From 588cce7e7e7b280f6f93b401a46626db83ba0799 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 09:30:10 +0000 Subject: [PATCH 001/557] add min_spin_oso (just a copy of min_spin) --- src/min_spin_oso.cpp | 333 +++++++++++++++++++++++++++++++++++++++++++ src/min_spin_oso.h | 59 ++++++++ 2 files changed, 392 insertions(+) create mode 100644 src/min_spin_oso.cpp create mode 100644 src/min_spin_oso.h diff --git a/src/min_spin_oso.cpp b/src/min_spin_oso.cpp new file mode 100644 index 0000000000..a97d7b40a1 --- /dev/null +++ b/src/min_spin_oso.cpp @@ -0,0 +1,333 @@ +/* ---------------------------------------------------------------------- + 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: Julien Tranchida (SNL) + + Please cite the related publication: +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +#include "min_spin_oso.h" +#include "universe.h" +#include "atom.h" +#include "force.h" +#include "update.h" +#include "output.h" +#include "timer.h" +#include "error.h" +#include "modify.h" +#include "math_special.h" +#include "math_const.h" + +using namespace LAMMPS_NS; +using namespace MathConst; + +// EPS_ENERGY = minimum normalization for energy tolerance + +#define EPS_ENERGY 1.0e-8 + +#define DELAYSTEP 5 + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO::MinSpinOSO(LAMMPS *lmp) : Min(lmp) {} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO::init() +{ + alpha_damp = 1.0; + discrete_factor = 10.0; + + Min::init(); + + dts = dt = update->dt; + last_negative = update->ntimestep; +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO::setup_style() +{ + double **v = atom->v; + int nlocal = atom->nlocal; + + // check if the atom/spin style is defined + + if (!atom->sp_flag) + error->all(FLERR,"min/spin_oso requires atom/spin style"); + + for (int i = 0; i < nlocal; i++) + v[i][0] = v[i][1] = v[i][2] = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +int MinSpinOSO::modify_param(int narg, char **arg) +{ + if (strcmp(arg[0],"alpha_damp") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + alpha_damp = force->numeric(FLERR,arg[1]); + return 2; + } + if (strcmp(arg[0],"discrete_factor") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + discrete_factor = force->numeric(FLERR,arg[1]); + return 2; + } + return 0; +} + +/* ---------------------------------------------------------------------- + set current vector lengths and pointers + called after atoms have migrated +------------------------------------------------------------------------- */ + +void MinSpinOSO::reset_vectors() +{ + // atomic dof + + // size sp is 4N vector + nvec = 4 * atom->nlocal; + if (nvec) spvec = atom->sp[0]; + + nvec = 3 * atom->nlocal; + if (nvec) fmvec = atom->fm[0]; + + if (nvec) xvec = atom->x[0]; + if (nvec) fvec = atom->f[0]; +} + +/* ---------------------------------------------------------------------- + minimization via damped spin dynamics +------------------------------------------------------------------------- */ + +int MinSpinOSO::iterate(int maxiter) +{ + bigint ntimestep; + double fmdotfm; + int flag, flagall; + + for (int iter = 0; iter < maxiter; iter++) { + + if (timer->check_timeout(niter)) + return TIMEOUT; + + ntimestep = ++update->ntimestep; + niter++; + + // optimize timestep accross processes / replicas + // need a force calculation for timestep optimization + + energy_force(0); + dts = evaluate_dt(); + + // apply damped precessional dynamics to the spins + + advance_spins(dts); + + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + + //// energy tolerance criterion + //// only check after DELAYSTEP elapsed since velocties reset to 0 + //// sync across replicas if running multi-replica minimization + + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { + if (update->multireplica == 0) { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + return ETOL; + } else { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return ETOL; + } + } + + // magnetic torque tolerance criterion + // sync across replicas if running multi-replica minimization + + if (update->ftol > 0.0) { + fmdotfm = fmnorm_sqr(); + if (update->multireplica == 0) { + if (fmdotfm < update->ftol*update->ftol) return FTOL; + } else { + if (fmdotfm < update->ftol*update->ftol) flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return FTOL; + } + } + + // output for thermo, dump, restart files + + if (output->next == ntimestep) { + timer->stamp(); + output->write(ntimestep); + timer->stamp(Timer::OUTPUT); + } + } + + return MAXITER; +} + +/* ---------------------------------------------------------------------- + evaluate max timestep +---------------------------------------------------------------------- */ + +double MinSpinOSO::evaluate_dt() +{ + double dtmax; + double fmsq; + double fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + double **fm = atom->fm; + + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + if (fmaxsqall == 0.0) + error->all(FLERR,"Incorrect fmaxsqall calculation"); + + // define max timestep by dividing by the + // inverse of max frequency by discrete_factor + + dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); + + return dtmax; +} + +/* ---------------------------------------------------------------------- + geometric damped advance of spins +---------------------------------------------------------------------- */ + +void MinSpinOSO::advance_spins(double dts) +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx,tdampy,tdampz; + double msq, scale, fm2, energy, dts2; + double cp[3], g[3]; + + dts2 = dts*dts; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + + // calc. damping torque + + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + // apply advance algorithm (geometric, norm preserving) + + fm2 = (tdampx*tdampx+tdampy*tdampy+tdampz*tdampz); + energy = (sp[i][0]*tdampx)+(sp[i][1]*tdampy)+(sp[i][2]*tdampz); + + cp[0] = tdampy*sp[i][2]-tdampz*sp[i][1]; + cp[1] = tdampz*sp[i][0]-tdampx*sp[i][2]; + cp[2] = tdampx*sp[i][1]-tdampy*sp[i][0]; + + g[0] = sp[i][0]+cp[0]*dts; + g[1] = sp[i][1]+cp[1]*dts; + g[2] = sp[i][2]+cp[2]*dts; + + g[0] += (tdampx*energy-0.5*sp[i][0]*fm2)*0.5*dts2; + g[1] += (tdampy*energy-0.5*sp[i][1]*fm2)*0.5*dts2; + g[2] += (tdampz*energy-0.5*sp[i][2]*fm2)*0.5*dts2; + + g[0] /= (1+0.25*fm2*dts2); + g[1] /= (1+0.25*fm2*dts2); + g[2] /= (1+0.25*fm2*dts2); + + sp[i][0] = g[0]; + sp[i][1] = g[1]; + sp[i][2] = g[2]; + + // 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 + } +} + +/* ---------------------------------------------------------------------- + compute and return ||mag. torque||_2^2 +------------------------------------------------------------------------- */ + +double MinSpinOSO::fmnorm_sqr() +{ + int nlocal = atom->nlocal; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + // calc. magnetic torques + + double local_norm2_sqr = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + local_norm2_sqr += tx*tx + ty*ty + tz*tz; + } + + // no extra atom calc. for spins + + if (nextra_atom) + error->all(FLERR,"extra atom option not available yet"); + + double norm2_sqr = 0.0; + MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); + + return norm2_sqr; +} + diff --git a/src/min_spin_oso.h b/src/min_spin_oso.h new file mode 100644 index 0000000000..81ad812e5c --- /dev/null +++ b/src/min_spin_oso.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. +------------------------------------------------------------------------- */ + +#ifdef MINIMIZE_CLASS + +MinimizeStyle(spin_oso, MinSpinOSO) + +#else + +#ifndef LMP_MIN_SPIN_OSO_H +#define LMP_MIN_SPIN_OSO_H + +#include "min.h" + +namespace LAMMPS_NS { + +class MinSpinOSO : public Min { + public: + MinSpinOSO(class LAMMPS *); //? + ~MinSpinOSO() {} //? + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); + double evaluate_dt(); + void advance_spins(double); + double fmnorm_sqr(); + + private: + + // global and spin timesteps + + double dt; + double dts; + + double alpha_damp; // damping for spin minimization + double discrete_factor; // factor for spin timestep evaluation + + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + + bigint last_negative; +}; + +} + +#endif +#endif From 1eb83136c4a86ad8d65e1d46284d8dc69a4a7858 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 10:59:15 +0000 Subject: [PATCH 002/557] add gradient descent with rotation matrices with adaptive time step (as before) --- src/min_spin_oso.cpp | 149 ++++++++++++++++++++++++++++++------------- 1 file changed, 105 insertions(+), 44 deletions(-) diff --git a/src/min_spin_oso.cpp b/src/min_spin_oso.cpp index a97d7b40a1..c20096ae1c 100644 --- a/src/min_spin_oso.cpp +++ b/src/min_spin_oso.cpp @@ -42,6 +42,9 @@ using namespace MathConst; #define DELAYSTEP 5 +void vm3(const double *m, const double *v, double *out); +void rodrigues_rotation(const double *upp_tr, double *out); + /* ---------------------------------------------------------------------- */ MinSpinOSO::MinSpinOSO(LAMMPS *lmp) : Min(lmp) {} @@ -244,58 +247,33 @@ void MinSpinOSO::advance_spins(double dts) int nlocal = atom->nlocal; double **sp = atom->sp; double **fm = atom->fm; - double tdampx,tdampy,tdampz; - double msq, scale, fm2, energy, dts2; - double cp[3], g[3]; - - dts2 = dts*dts; + double tdampx, tdampy, tdampz; + double f[3]; // upper triag. part of skew-symm. matr. to be exponented + double rot_mat[9]; // exponential of a + double s_new[3]; // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - // calc. damping torque + // calc. damping torque + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + // calculate rotation matrix + f[0] = tdampz * dts; + f[1] = -tdampy * dts; + f[2] = tdampx * dts; + rodrigues_rotation(f, rot_mat); - // apply advance algorithm (geometric, norm preserving) - - fm2 = (tdampx*tdampx+tdampy*tdampy+tdampz*tdampz); - energy = (sp[i][0]*tdampx)+(sp[i][1]*tdampy)+(sp[i][2]*tdampz); - - cp[0] = tdampy*sp[i][2]-tdampz*sp[i][1]; - cp[1] = tdampz*sp[i][0]-tdampx*sp[i][2]; - cp[2] = tdampx*sp[i][1]-tdampy*sp[i][0]; - - g[0] = sp[i][0]+cp[0]*dts; - g[1] = sp[i][1]+cp[1]*dts; - g[2] = sp[i][2]+cp[2]*dts; - - g[0] += (tdampx*energy-0.5*sp[i][0]*fm2)*0.5*dts2; - g[1] += (tdampy*energy-0.5*sp[i][1]*fm2)*0.5*dts2; - g[2] += (tdampz*energy-0.5*sp[i][2]*fm2)*0.5*dts2; - - g[0] /= (1+0.25*fm2*dts2); - g[1] /= (1+0.25*fm2*dts2); - g[2] /= (1+0.25*fm2*dts2); - - sp[i][0] = g[0]; - sp[i][1] = g[1]; - sp[i][2] = g[2]; - - // 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 + // rotate spins + vm3(rot_mat, sp[i], s_new); + sp[i][0] = s_new[0]; + sp[i][1] = s_new[1]; + sp[i][2] = s_new[2]; } + } /* ---------------------------------------------------------------------- @@ -331,3 +309,86 @@ double MinSpinOSO::fmnorm_sqr() return norm2_sqr; } + +void rodrigues_rotation(const double *upp_tr, double *out){ + + /*** + * calculate 3x3 matrix exponential using Rodrigues' formula + * (R. Murray, Z. Li, and S. Shankar Sastry, + * A Mathematical Introduction to + * Robotic Manipulation (1994), p. 28 and 30). + * + * upp_tr - vector x, y, z so that one calculate + * U = exp(A) with A= [[0, x, y], + * [-x, 0, z], + * [-y, -z, 0]] + ***/ + + + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + // if upp_tr is zero, return unity matrix + int k; + int m; + for(k = 0; k < 3; k++){ + for(m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } + } + return; + } + + double theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); + + double A = cos(theta); + double B = sin(theta); + double D = 1 - A; + double x = upp_tr[0]/theta; + double y = upp_tr[1]/theta; + double z = upp_tr[2]/theta; + + // diagonal elements of U + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; + + // off diagonal of U + double s1 = -y * z *D; + double s2 = x * z * D; + double s3 = -x * y * D; + + double a1 = x * B; + double a2 = y * B; + double a3 = z * B; + + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; + +} + + +void vm3(const double *m, const double *v, double *out){ + /*** + * out = vector^T x m, + * m -- 3x3 matrix , v -- 3-d vector + ***/ + + int i; + int j; + + for(i = 0; i < 3; i++){ + out[i] *= 0.0; + for(j = 0; j < 3; j++){ + out[i] += *(m + 3 * j + i) * v[j]; + } + } + +} From f7ddf433ef03dc94fcf5e5e50a3d61018abe8e06 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 13:14:27 +0000 Subject: [PATCH 003/557] modify comment --- src/min_spin_oso.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/min_spin_oso.cpp b/src/min_spin_oso.cpp index c20096ae1c..d26a7ffc39 100644 --- a/src/min_spin_oso.cpp +++ b/src/min_spin_oso.cpp @@ -239,7 +239,7 @@ double MinSpinOSO::evaluate_dt() } /* ---------------------------------------------------------------------- - geometric damped advance of spins + rotation of spins along the search direction ---------------------------------------------------------------------- */ void MinSpinOSO::advance_spins(double dts) From 56e1032c1d0fcb7d47e8c46a5aed9e4feef5af7f Mon Sep 17 00:00:00 2001 From: Jared Date: Thu, 27 Jun 2019 17:50:45 +0200 Subject: [PATCH 004/557] Update gcmc to have a max and min --- src/MC/fix_gcmc.cpp | 24 ++++++++++++++++++++---- src/MC/fix_gcmc.h | 2 ++ 2 files changed, 22 insertions(+), 4 deletions(-) diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 7ab0879335..5cf655b1de 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -391,6 +391,14 @@ void FixGCMC::options(int narg, char **arg) overlap_cutoffsq = rtmp*rtmp; overlap_flag = 1; iarg += 2; + } else if (strcmp(arg[iarg],"min") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix gcmc command"); + min_ngas = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"max") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix gcmc command"); + max_ngas = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; } else error->all(FLERR,"Illegal fix gcmc command"); } } @@ -897,7 +905,7 @@ void FixGCMC::attempt_atomic_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; int i = pick_random_gas_atom(); @@ -938,6 +946,8 @@ void FixGCMC::attempt_atomic_insertion() ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + // pick coordinates for insertion point double coord[3]; @@ -1252,7 +1262,7 @@ void FixGCMC::attempt_molecule_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -1291,6 +1301,8 @@ void FixGCMC::attempt_molecule_insertion() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double com_coord[3]; if (regionflag) { int region_attempt = 0; @@ -1574,7 +1586,7 @@ void FixGCMC::attempt_atomic_deletion_full() ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; double energy_before = energy_stored; @@ -1623,6 +1635,8 @@ void FixGCMC::attempt_atomic_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double energy_before = energy_stored; double coord[3]; @@ -1918,7 +1932,7 @@ void FixGCMC::attempt_molecule_deletion_full() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -2001,6 +2015,8 @@ void FixGCMC::attempt_molecule_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double energy_before = energy_stored; tagint maxmol = 0; diff --git a/src/MC/fix_gcmc.h b/src/MC/fix_gcmc.h index 5d0b7aab8f..e19a42ef73 100644 --- a/src/MC/fix_gcmc.h +++ b/src/MC/fix_gcmc.h @@ -120,6 +120,8 @@ class FixGCMC : public Fix { imageint imagezero; double overlap_cutoffsq; // square distance cutoff for overlap int overlap_flag; + int max_ngas; + int min_ngas; double energy_intra; From 589d0e2a6a53c760937b2b9b19c28f41c90db341 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 16:26:24 +0000 Subject: [PATCH 005/557] add conjugate gradients with OSO --- .../min_spin_oso_cg.cpp} | 148 +++++++++++++----- src/SPIN/min_spin_oso_cg.h | 65 ++++++++ src/min_spin_oso.h | 59 ------- 3 files changed, 177 insertions(+), 95 deletions(-) rename src/{min_spin_oso.cpp => SPIN/min_spin_oso_cg.cpp} (72%) create mode 100644 src/SPIN/min_spin_oso_cg.h delete mode 100644 src/min_spin_oso.h diff --git a/src/min_spin_oso.cpp b/src/SPIN/min_spin_oso_cg.cpp similarity index 72% rename from src/min_spin_oso.cpp rename to src/SPIN/min_spin_oso_cg.cpp index d26a7ffc39..9f43442e27 100644 --- a/src/min_spin_oso.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -21,7 +21,7 @@ #include #include #include -#include "min_spin_oso.h" +#include "min_spin_oso_cg.h" #include "universe.h" #include "atom.h" #include "force.h" @@ -47,24 +47,24 @@ void rodrigues_rotation(const double *upp_tr, double *out); /* ---------------------------------------------------------------------- */ -MinSpinOSO::MinSpinOSO(LAMMPS *lmp) : Min(lmp) {} +MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : Min(lmp) {} /* ---------------------------------------------------------------------- */ -void MinSpinOSO::init() +void MinSpinOSO_CG::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; + alpha_damp = 1.0; + discrete_factor = 10.0; - Min::init(); + Min::init(); - dts = dt = update->dt; - last_negative = update->ntimestep; + dts = dt = update->dt; + last_negative = update->ntimestep; } /* ---------------------------------------------------------------------- */ -void MinSpinOSO::setup_style() +void MinSpinOSO_CG::setup_style() { double **v = atom->v; int nlocal = atom->nlocal; @@ -72,7 +72,7 @@ void MinSpinOSO::setup_style() // check if the atom/spin style is defined if (!atom->sp_flag) - error->all(FLERR,"min/spin_oso requires atom/spin style"); + error->all(FLERR,"min/spin_oso_cg requires atom/spin style"); for (int i = 0; i < nlocal; i++) v[i][0] = v[i][1] = v[i][2] = 0.0; @@ -80,7 +80,7 @@ void MinSpinOSO::setup_style() /* ---------------------------------------------------------------------- */ -int MinSpinOSO::modify_param(int narg, char **arg) +int MinSpinOSO_CG::modify_param(int narg, char **arg) { if (strcmp(arg[0],"alpha_damp") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); @@ -100,7 +100,7 @@ int MinSpinOSO::modify_param(int narg, char **arg) called after atoms have migrated ------------------------------------------------------------------------- */ -void MinSpinOSO::reset_vectors() +void MinSpinOSO_CG::reset_vectors() { // atomic dof @@ -119,13 +119,19 @@ void MinSpinOSO::reset_vectors() minimization via damped spin dynamics ------------------------------------------------------------------------- */ -int MinSpinOSO::iterate(int maxiter) +int MinSpinOSO_CG::iterate(int maxiter) { - bigint ntimestep; - double fmdotfm; - int flag, flagall; + bigint ntimestep; + double fmdotfm; + int flag, flagall; - for (int iter = 0; iter < maxiter; iter++) { + // not sure it is best place to allocate memory + int nlocal = atom->nlocal; + g = (double *) calloc(3*nlocal, sizeof(double)); + p = (double *) calloc(3*nlocal, sizeof(double)); + g_old = (double *) calloc(3*nlocal, sizeof(double)); + + for (int iter = 0; iter < maxiter; iter++) { if (timer->check_timeout(niter)) return TIMEOUT; @@ -139,9 +145,9 @@ int MinSpinOSO::iterate(int maxiter) energy_force(0); dts = evaluate_dt(); - // apply damped precessional dynamics to the spins - - advance_spins(dts); + calc_gradients(dts); + calc_search_direction(iter); + advance_spins(); eprevious = ecurrent; ecurrent = energy_force(0); @@ -190,6 +196,10 @@ int MinSpinOSO::iterate(int maxiter) } } + free(p); + free(g); + free(g_old); + return MAXITER; } @@ -197,7 +207,7 @@ int MinSpinOSO::iterate(int maxiter) evaluate max timestep ---------------------------------------------------------------------- */ -double MinSpinOSO::evaluate_dt() +double MinSpinOSO_CG::evaluate_dt() { double dtmax; double fmsq; @@ -238,35 +248,101 @@ double MinSpinOSO::evaluate_dt() return dtmax; } +/* ---------------------------------------------------------------------- + calculate gradients +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG::calc_gradients(double dts) +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + + // calc. damping torque + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + // calculate rotation matrix + g[3 * i + 0] = -tdampz * dts; + g[3 * i + 1] = tdampy * dts; + g[3 * i + 2] = -tdampx * dts; + } +} + +void MinSpinOSO_CG::calc_search_direction(int iter) +{ + int nlocal = atom->nlocal; + double g2old = 0.0; + double g2 = 0.0; + double beta = 0.0; + + double g2_global= 0.0; + double g2old_global= 0.0; + + // for some reason on a second iteration g_old = 0 + // so we make to iterations as steepest descent + if (iter <= 2 || iter % 5 == 0){ + // steepest descent direction + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + p[3 * i + j] = -g[3 * i + j]; + g_old[3 * i + j] = g[3 * i + j]; + } + } + } else{ + // conjugate direction + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + g2old += g_old[3 * i + j] * g_old[3 * i + j]; + g2 += g[3 * i + j] * g[3 * i + j]; + + } + } + + // now we need to collect/broadcast beta on this replica + // different replica can have different beta for now. + // need to check what is beta for GNEB + MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); + + beta = g2_global / g2old_global; + + //calculate conjugate direction + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + p[3 * i + j] = beta * p[3 * i + j] - g[3 * i + j]; + g_old[3 * i + j] = g[3 * i + j]; + } + } + + } + +} + + /* ---------------------------------------------------------------------- rotation of spins along the search direction ---------------------------------------------------------------------- */ -void MinSpinOSO::advance_spins(double dts) +void MinSpinOSO_CG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; double **fm = atom->fm; double tdampx, tdampy, tdampz; - double f[3]; // upper triag. part of skew-symm. matr. to be exponented + // double f[3]; // upper triag. part of skew-symm. matr. to be exponented double rot_mat[9]; // exponential of a double s_new[3]; // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - - // calc. damping torque - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - // calculate rotation matrix - f[0] = tdampz * dts; - f[1] = -tdampy * dts; - f[2] = tdampx * dts; - rodrigues_rotation(f, rot_mat); - + rodrigues_rotation(p + 3 * i, rot_mat); // rotate spins vm3(rot_mat, sp[i], s_new); sp[i][0] = s_new[0]; @@ -280,7 +356,7 @@ void MinSpinOSO::advance_spins(double dts) compute and return ||mag. torque||_2^2 ------------------------------------------------------------------------- */ -double MinSpinOSO::fmnorm_sqr() +double MinSpinOSO_CG::fmnorm_sqr() { int nlocal = atom->nlocal; double tx,ty,tz; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h new file mode 100644 index 0000000000..fa0b591c21 --- /dev/null +++ b/src/SPIN/min_spin_oso_cg.h @@ -0,0 +1,65 @@ +/* -*- 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 MINIMIZE_CLASS + +MinimizeStyle(spin_oso_cg, MinSpinOSO_CG) + +#else + +#ifndef LMP_MIN_SPIN_OSO_CG_H +#define LMP_MIN_SPIN_OSO_CG_H + +#include "min.h" + +namespace LAMMPS_NS { + +class MinSpinOSO_CG : public Min { + +public: + MinSpinOSO_CG(class LAMMPS *); //? + ~MinSpinOSO_CG() {} //? + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); + double evaluate_dt(); + void advance_spins(); + double fmnorm_sqr(); + void calc_gradients(double); + void calc_search_direction(int); + +private: + // global and spin timesteps + + double dt; + double dts; + + double alpha_damp; // damping for spin minimization + double discrete_factor; // factor for spin timestep evaluation + + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + + double *g_old; // gradient vector + double *g; // gradient vector + double *p; // search direction vector + + bigint last_negative; +}; + +} + +#endif +#endif diff --git a/src/min_spin_oso.h b/src/min_spin_oso.h deleted file mode 100644 index 81ad812e5c..0000000000 --- a/src/min_spin_oso.h +++ /dev/null @@ -1,59 +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 MINIMIZE_CLASS - -MinimizeStyle(spin_oso, MinSpinOSO) - -#else - -#ifndef LMP_MIN_SPIN_OSO_H -#define LMP_MIN_SPIN_OSO_H - -#include "min.h" - -namespace LAMMPS_NS { - -class MinSpinOSO : public Min { - public: - MinSpinOSO(class LAMMPS *); //? - ~MinSpinOSO() {} //? - void init(); - void setup_style(); - int modify_param(int, char **); - void reset_vectors(); - int iterate(int); - double evaluate_dt(); - void advance_spins(double); - double fmnorm_sqr(); - - private: - - // global and spin timesteps - - double dt; - double dts; - - double alpha_damp; // damping for spin minimization - double discrete_factor; // factor for spin timestep evaluation - - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - - bigint last_negative; -}; - -} - -#endif -#endif From 630ce7b96247b3d8bf23f54c83c04fef8da79c61 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 16:31:24 +0000 Subject: [PATCH 006/557] add contributing authors --- src/SPIN/min_spin_oso_cg.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 9f43442e27..b36e5f280f 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing authors: Julien Tranchida (SNL) + Contributing authors: Julien Tranchida (SNL), Aleksei Ivanov (UI) Please cite the related publication: ------------------------------------------------------------------------- */ From 2520eab46d844bda3e30111d1c8f06d94a009a82 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 27 Jun 2019 16:41:19 +0000 Subject: [PATCH 007/557] small typo --- src/SPIN/min_spin_oso_cg.cpp | 13 ++++++------- src/SPIN/min_spin_oso_cg.h | 4 ++-- 2 files changed, 8 insertions(+), 9 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index b36e5f280f..9c084d9684 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -145,7 +145,7 @@ int MinSpinOSO_CG::iterate(int maxiter) energy_force(0); dts = evaluate_dt(); - calc_gradients(dts); + calc_gradient(dts); calc_search_direction(iter); advance_spins(); @@ -252,7 +252,7 @@ double MinSpinOSO_CG::evaluate_dt() calculate gradients ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::calc_gradients(double dts) +void MinSpinOSO_CG::calc_gradient(double dts) { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -267,7 +267,7 @@ void MinSpinOSO_CG::calc_gradients(double dts) tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - // calculate rotation matrix + // calculate gradients g[3 * i + 0] = -tdampz * dts; g[3 * i + 1] = tdampy * dts; g[3 * i + 2] = -tdampx * dts; @@ -285,7 +285,7 @@ void MinSpinOSO_CG::calc_search_direction(int iter) double g2old_global= 0.0; // for some reason on a second iteration g_old = 0 - // so we make to iterations as steepest descent + // so we make two iterations as steepest descent if (iter <= 2 || iter % 5 == 0){ // steepest descent direction for (int i = 0; i < nlocal; i++) { @@ -312,7 +312,7 @@ void MinSpinOSO_CG::calc_search_direction(int iter) beta = g2_global / g2old_global; - //calculate conjugate direction + // calculate conjugate direction for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++){ p[3 * i + j] = beta * p[3 * i + j] - g[3 * i + j]; @@ -335,8 +335,7 @@ void MinSpinOSO_CG::advance_spins() double **sp = atom->sp; double **fm = atom->fm; double tdampx, tdampy, tdampz; - // double f[3]; // upper triag. part of skew-symm. matr. to be exponented - double rot_mat[9]; // exponential of a + double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; // loop on all spins on proc. diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index fa0b591c21..a2ecf53e55 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -37,7 +37,7 @@ public: double evaluate_dt(); void advance_spins(); double fmnorm_sqr(); - void calc_gradients(double); + void calc_gradient(double); void calc_search_direction(int); private: @@ -52,7 +52,7 @@ private: double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector + double *g_old; // gradient vector at previous iteration double *g; // gradient vector double *p; // search direction vector From 3e8ab7cbb00f42745794afa5205ed4cafbea24f6 Mon Sep 17 00:00:00 2001 From: julient31 Date: Thu, 27 Jun 2019 15:15:57 -0600 Subject: [PATCH 008/557] Commit JT 062719 - cleaned code and setup LAMMPS format and indentation - added src/min_spin_oso_cg.h/cpp to .gitignore --- src/.gitignore | 2 + src/SPIN/min_spin_oso_cg.cpp | 340 ++++++++++++++++++----------------- src/SPIN/min_spin_oso_cg.h | 23 +-- 3 files changed, 193 insertions(+), 172 deletions(-) diff --git a/src/.gitignore b/src/.gitignore index c79c958e6d..0d802981f9 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -161,6 +161,8 @@ /fix_setforce_spin.h /min_spin.cpp /min_spin.h +/min_spin_oso_cg.cpp +/min_spin_oso_cg.h /neb_spin.cpp /neb_spin.h /pair_spin.cpp diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 9c084d9684..c09d12dbc8 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -12,9 +12,13 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing authors: Julien Tranchida (SNL), Aleksei Ivanov (UI) + Contributing authors: Aleksei Ivanov (UI) + Julien Tranchida (SNL) Please cite the related publication: + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + preprint arXiv:1904.02669. ------------------------------------------------------------------------- */ #include @@ -24,6 +28,7 @@ #include "min_spin_oso_cg.h" #include "universe.h" #include "atom.h" +#include "citeme.h" #include "force.h" #include "update.h" #include "output.h" @@ -36,30 +41,40 @@ using namespace LAMMPS_NS; using namespace MathConst; +static const char cite_minstyle_spin_oso_cg[] = + "min_style spin/oso_cg command:\n\n" + "@article{ivanov2019fast,\n" + "title={Fast and Robust Algorithm for the Minimisation of the Energy of " + "Spin Systems},\n" + "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" + "journal={arXiv preprint arXiv:1904.02669},\n" + "year={2019}\n" + "}\n\n"; + // EPS_ENERGY = minimum normalization for energy tolerance #define EPS_ENERGY 1.0e-8 #define DELAYSTEP 5 -void vm3(const double *m, const double *v, double *out); -void rodrigues_rotation(const double *upp_tr, double *out); /* ---------------------------------------------------------------------- */ -MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : Min(lmp) {} +MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : Min(lmp) { + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); +} /* ---------------------------------------------------------------------- */ void MinSpinOSO_CG::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; + alpha_damp = 1.0; + discrete_factor = 10.0; - Min::init(); + Min::init(); - dts = dt = update->dt; - last_negative = update->ntimestep; + dts = dt = update->dt; + last_negative = update->ntimestep; } /* ---------------------------------------------------------------------- */ @@ -121,34 +136,34 @@ void MinSpinOSO_CG::reset_vectors() int MinSpinOSO_CG::iterate(int maxiter) { - bigint ntimestep; - double fmdotfm; - int flag, flagall; + bigint ntimestep; + double fmdotfm; + int flag, flagall; - // not sure it is best place to allocate memory - int nlocal = atom->nlocal; - g = (double *) calloc(3*nlocal, sizeof(double)); - p = (double *) calloc(3*nlocal, sizeof(double)); - g_old = (double *) calloc(3*nlocal, sizeof(double)); - - for (int iter = 0; iter < maxiter; iter++) { + // not sure it is best place to allocate memory + int nlocal = atom->nlocal; + g = (double *) calloc(3*nlocal, sizeof(double)); + p = (double *) calloc(3*nlocal, sizeof(double)); + g_old = (double *) calloc(3*nlocal, sizeof(double)); + for (int iter = 0; iter < maxiter; iter++) { + if (timer->check_timeout(niter)) return TIMEOUT; - + ntimestep = ++update->ntimestep; niter++; - + // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - + energy_force(0); dts = evaluate_dt(); - + calc_gradient(dts); calc_search_direction(iter); advance_spins(); - + eprevious = ecurrent; ecurrent = energy_force(0); neval++; @@ -156,7 +171,7 @@ int MinSpinOSO_CG::iterate(int maxiter) //// energy tolerance criterion //// only check after DELAYSTEP elapsed since velocties reset to 0 //// sync across replicas if running multi-replica minimization - + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { if (update->multireplica == 0) { if (fabs(ecurrent-eprevious) < @@ -196,9 +211,9 @@ int MinSpinOSO_CG::iterate(int maxiter) } } - free(p); - free(g); - free(g_old); + free(p); + free(g); + free(g_old); return MAXITER; } @@ -254,76 +269,80 @@ double MinSpinOSO_CG::evaluate_dt() void MinSpinOSO_CG::calc_gradient(double dts) { - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - // loop on all spins on proc. + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + + // loop on all spins on proc. - for (int i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { + + // calc. damping torque + + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - // calc. damping torque - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - // calculate gradients - g[3 * i + 0] = -tdampz * dts; - g[3 * i + 1] = tdampy * dts; - g[3 * i + 2] = -tdampx * dts; - } + // calculate gradients + + g[3 * i + 0] = -tdampz * dts; + g[3 * i + 1] = tdampy * dts; + g[3 * i + 2] = -tdampx * dts; + } } +/* ---------------------------------------------------------------------- + search direction +---------------------------------------------------------------------- */ + void MinSpinOSO_CG::calc_search_direction(int iter) { - int nlocal = atom->nlocal; - double g2old = 0.0; - double g2 = 0.0; - double beta = 0.0; + int nlocal = atom->nlocal; + double g2old = 0.0; + double g2 = 0.0; + double beta = 0.0; - double g2_global= 0.0; - double g2old_global= 0.0; - - // for some reason on a second iteration g_old = 0 - // so we make two iterations as steepest descent - if (iter <= 2 || iter % 5 == 0){ - // steepest descent direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p[3 * i + j] = -g[3 * i + j]; - g_old[3 * i + j] = g[3 * i + j]; - } - } - } else{ - // conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - g2old += g_old[3 * i + j] * g_old[3 * i + j]; - g2 += g[3 * i + j] * g[3 * i + j]; - - } - } - - // now we need to collect/broadcast beta on this replica - // different replica can have different beta for now. - // need to check what is beta for GNEB - MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); - MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); - - beta = g2_global / g2old_global; - - // calculate conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p[3 * i + j] = beta * p[3 * i + j] - g[3 * i + j]; - g_old[3 * i + j] = g[3 * i + j]; - } - } + double g2_global= 0.0; + double g2old_global= 0.0; + // for some reason on a second iteration g_old = 0 + // so we make two iterations as steepest descent + + if (iter <= 2 || iter % 5 == 0){ // steepest descent direction + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + p[3 * i + j] = -g[3 * i + j]; + g_old[3 * i + j] = g[3 * i + j]; + } + } + } else { // conjugate direction + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + g2old += g_old[3 * i + j] * g_old[3 * i + j]; + g2 += g[3 * i + j] * g[3 * i + j]; + } } -} + // now we need to collect/broadcast beta on this replica + // different replica can have different beta for now. + // need to check what is beta for GNEB + + MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); + beta = g2_global / g2old_global; + + // calculate conjugate direction + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++){ + p[3 * i + j] = beta * p[3 * i + j] - g[3 * i + j]; + g_old[3 * i + j] = g[3 * i + j]; + } + } + } +} /* ---------------------------------------------------------------------- rotation of spins along the search direction @@ -341,14 +360,15 @@ void MinSpinOSO_CG::advance_spins() // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p + 3 * i, rot_mat); - // rotate spins - vm3(rot_mat, sp[i], s_new); - sp[i][0] = s_new[0]; - sp[i][1] = s_new[1]; - sp[i][2] = s_new[2]; + rodrigues_rotation(p + 3 * i, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + sp[i][0] = s_new[0]; + sp[i][1] = s_new[1]; + sp[i][2] = s_new[2]; } - } /* ---------------------------------------------------------------------- @@ -384,86 +404,82 @@ double MinSpinOSO_CG::fmnorm_sqr() return norm2_sqr; } +/* ---------------------------------------------------------------------- + calculate 3x3 matrix exponential using Rodrigues' formula + (R. Murray, Z. Li, and S. Shankar Sastry, + A Mathematical Introduction to + Robotic Manipulation (1994), p. 28 and 30). + + upp_tr - vector x, y, z so that one calculate + U = exp(A) with A= [[0, x, y], + [-x, 0, z], + [-y, -z, 0]] +------------------------------------------------------------------------- */ -void rodrigues_rotation(const double *upp_tr, double *out){ +void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) +{ - /*** - * calculate 3x3 matrix exponential using Rodrigues' formula - * (R. Murray, Z. Li, and S. Shankar Sastry, - * A Mathematical Introduction to - * Robotic Manipulation (1994), p. 28 and 30). - * - * upp_tr - vector x, y, z so that one calculate - * U = exp(A) with A= [[0, x, y], - * [-x, 0, z], - * [-y, -z, 0]] - ***/ - - - if (fabs(upp_tr[0]) < 1.0e-40 && - fabs(upp_tr[1]) < 1.0e-40 && - fabs(upp_tr[2]) < 1.0e-40){ - // if upp_tr is zero, return unity matrix - int k; - int m; - for(k = 0; k < 3; k++){ - for(m = 0; m < 3; m++){ - if (m == k) out[3 * k + m] = 1.0; - else out[3 * k + m] = 0.0; - } - } - return; + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + + // if upp_tr is zero, return unity matrix + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } } + return; + } - double theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); + double theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); - double A = cos(theta); - double B = sin(theta); - double D = 1 - A; - double x = upp_tr[0]/theta; - double y = upp_tr[1]/theta; - double z = upp_tr[2]/theta; + double A = cos(theta); + double B = sin(theta); + double D = 1 - A; + double x = upp_tr[0]/theta; + double y = upp_tr[1]/theta; + double z = upp_tr[2]/theta; - // diagonal elements of U - out[0] = A + z * z * D; - out[4] = A + y * y * D; - out[8] = A + x * x * D; + // diagonal elements of U + + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; - // off diagonal of U - double s1 = -y * z *D; - double s2 = x * z * D; - double s3 = -x * y * D; + // off diagonal of U + + double s1 = -y * z *D; + double s2 = x * z * D; + double s3 = -x * y * D; - double a1 = x * B; - double a2 = y * B; - double a3 = z * B; + double a1 = x * B; + double a2 = y * B; + double a3 = z * B; - out[1] = s1 + a1; - out[3] = s1 - a1; - out[2] = s2 + a2; - out[6] = s2 - a2; - out[5] = s3 + a3; - out[7] = s3 - a3; + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; } +/* ---------------------------------------------------------------------- + out = vector^T x m, + m -- 3x3 matrix , v -- 3-d vector +------------------------------------------------------------------------- */ -void vm3(const double *m, const double *v, double *out){ - /*** - * out = vector^T x m, - * m -- 3x3 matrix , v -- 3-d vector - ***/ - - int i; - int j; - - for(i = 0; i < 3; i++){ - out[i] *= 0.0; - for(j = 0; j < 3; j++){ - out[i] += *(m + 3 * j + i) * v[j]; - } +void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) +{ + for(int i = 0; i < 3; i++){ + out[i] *= 0.0; + for(int j = 0; j < 3; j++){ + out[i] += *(m + 3 * j + i) * v[j]; } - + } } diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index a2ecf53e55..8cff52431c 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -13,7 +13,7 @@ #ifdef MINIMIZE_CLASS -MinimizeStyle(spin_oso_cg, MinSpinOSO_CG) +MinimizeStyle(spin/oso_cg, MinSpinOSO_CG) #else @@ -27,8 +27,8 @@ namespace LAMMPS_NS { class MinSpinOSO_CG : public Min { public: - MinSpinOSO_CG(class LAMMPS *); //? - ~MinSpinOSO_CG() {} //? + MinSpinOSO_CG(class LAMMPS *); + ~MinSpinOSO_CG() {} void init(); void setup_style(); int modify_param(int, char **); @@ -46,15 +46,18 @@ private: double dt; double dts; - double alpha_damp; // damping for spin minimization - double discrete_factor; // factor for spin timestep evaluation + double alpha_damp; // damping for spin minimization + double discrete_factor; // factor for spin timestep evaluation - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous iteration - double *g; // gradient vector - double *p; // search direction vector + double *g_old; // gradient vector at previous iteration + double *g; // gradient vector + double *p; // search direction vector + + void vm3(const double *m, const double *v, double *out); + void rodrigues_rotation(const double *upp_tr, double *out); bigint last_negative; }; From 5c8e81241aba49399ef221bc841ccdc249cc08c1 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 28 Jun 2019 10:49:21 -0600 Subject: [PATCH 009/557] Commit JT 062819 - modified memory allocation --- src/SPIN/fix_nve_spin.h | 2 +- src/SPIN/min_spin_oso_cg.cpp | 90 ++++++++++++++++++++++-------------- src/SPIN/min_spin_oso_cg.h | 11 +++-- 3 files changed, 63 insertions(+), 40 deletions(-) diff --git a/src/SPIN/fix_nve_spin.h b/src/SPIN/fix_nve_spin.h index 4800575c06..89cd617e0b 100644 --- a/src/SPIN/fix_nve_spin.h +++ b/src/SPIN/fix_nve_spin.h @@ -54,7 +54,7 @@ friend class PairSpin; double dtv, dtf, dts; // velocity, force, and spin timesteps - int nlocal_max; // max value of nlocal (for lists size) + int nlocal_max; // max value of nlocal (for size of lists) int pair_spin_flag; // magnetic pair flags int long_spin_flag; // magnetic long-range flag diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index c09d12dbc8..d6bca32a40 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -34,6 +34,7 @@ #include "output.h" #include "timer.h" #include "error.h" +#include "memory.h" #include "modify.h" #include "math_special.h" #include "math_const.h" @@ -60,8 +61,20 @@ static const char cite_minstyle_spin_oso_cg[] = /* ---------------------------------------------------------------------- */ -MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : Min(lmp) { +MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL) +{ if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); + nlocal_max = 0; +} + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_CG::~MinSpinOSO_CG() +{ + memory->destroy(g_old); + memory->destroy(g_cur); + memory->destroy(p_s); } /* ---------------------------------------------------------------------- */ @@ -75,6 +88,13 @@ void MinSpinOSO_CG::init() dts = dt = update->dt; last_negative = update->ntimestep; + + // allocate tables + + nlocal_max = atom->nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); } /* ---------------------------------------------------------------------- */ @@ -134,17 +154,21 @@ void MinSpinOSO_CG::reset_vectors() minimization via damped spin dynamics ------------------------------------------------------------------------- */ +// g_old g_cur p_s + int MinSpinOSO_CG::iterate(int maxiter) { + int nlocal = atom->nlocal; bigint ntimestep; double fmdotfm; int flag, flagall; - // not sure it is best place to allocate memory - int nlocal = atom->nlocal; - g = (double *) calloc(3*nlocal, sizeof(double)); - p = (double *) calloc(3*nlocal, sizeof(double)); - g_old = (double *) calloc(3*nlocal, sizeof(double)); + if (nlocal_max < nlocal) { + nlocal_max = nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + } for (int iter = 0; iter < maxiter; iter++) { @@ -211,10 +235,6 @@ int MinSpinOSO_CG::iterate(int maxiter) } } - free(p); - free(g); - free(g_old); - return MAXITER; } @@ -286,9 +306,9 @@ void MinSpinOSO_CG::calc_gradient(double dts) // calculate gradients - g[3 * i + 0] = -tdampz * dts; - g[3 * i + 1] = tdampy * dts; - g[3 * i + 2] = -tdampx * dts; + g_cur[3 * i + 0] = -tdampz * dts; + g_cur[3 * i + 1] = tdampy * dts; + g_cur[3 * i + 2] = -tdampx * dts; } } @@ -312,15 +332,15 @@ void MinSpinOSO_CG::calc_search_direction(int iter) if (iter <= 2 || iter % 5 == 0){ // steepest descent direction for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++){ - p[3 * i + j] = -g[3 * i + j]; - g_old[3 * i + j] = g[3 * i + j]; + p_s[3 * i + j] = -g_cur[3 * i + j]; + g_old[3 * i + j] = g_cur[3 * i + j]; } } } else { // conjugate direction for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++){ g2old += g_old[3 * i + j] * g_old[3 * i + j]; - g2 += g[3 * i + j] * g[3 * i + j]; + g2 += g_cur[3 * i + j] * g_cur[3 * i + j]; } } @@ -337,8 +357,8 @@ void MinSpinOSO_CG::calc_search_direction(int iter) for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++){ - p[3 * i + j] = beta * p[3 * i + j] - g[3 * i + j]; - g_old[3 * i + j] = g[3 * i + j]; + p_s[3 * i + j] = beta * p_s[3 * i + j] - g_cur[3 * i + j]; + g_old[3 * i + j] = g_cur[3 * i + j]; } } } @@ -360,7 +380,7 @@ void MinSpinOSO_CG::advance_spins() // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p + 3 * i, rot_mat); + rodrigues_rotation(p_s + 3 * i, rot_mat); // rotate spins @@ -418,6 +438,8 @@ double MinSpinOSO_CG::fmnorm_sqr() void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) { + double theta,A,B,D,x,y,z; + double s1,s2,s3,a1,a2,a3; if (fabs(upp_tr[0]) < 1.0e-40 && fabs(upp_tr[1]) < 1.0e-40 && @@ -433,16 +455,16 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) return; } - double theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); + theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); - double A = cos(theta); - double B = sin(theta); - double D = 1 - A; - double x = upp_tr[0]/theta; - double y = upp_tr[1]/theta; - double z = upp_tr[2]/theta; + A = cos(theta); + B = sin(theta); + D = 1 - A; + x = upp_tr[0]/theta; + y = upp_tr[1]/theta; + z = upp_tr[2]/theta; // diagonal elements of U @@ -452,13 +474,13 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) // off diagonal of U - double s1 = -y * z *D; - double s2 = x * z * D; - double s3 = -x * y * D; + s1 = -y * z *D; + s2 = x * z * D; + s3 = -x * y * D; - double a1 = x * B; - double a2 = y * B; - double a3 = z * B; + a1 = x * B; + a2 = y * B; + a3 = z * B; out[1] = s1 + a1; out[3] = s1 - a1; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index 8cff52431c..a791754836 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -28,7 +28,7 @@ class MinSpinOSO_CG : public Min { public: MinSpinOSO_CG(class LAMMPS *); - ~MinSpinOSO_CG() {} + virtual ~MinSpinOSO_CG(); void init(); void setup_style(); int modify_param(int, char **); @@ -43,6 +43,7 @@ public: private: // global and spin timesteps + int nlocal_max; // max value of nlocal (for size of lists) double dt; double dts; @@ -53,11 +54,11 @@ private: double *fmvec; // variables for atomic dof, as 1d vector double *g_old; // gradient vector at previous iteration - double *g; // gradient vector - double *p; // search direction vector + double *g_cur; // current gradient vector + double *p_s; // search direction vector - void vm3(const double *m, const double *v, double *out); - void rodrigues_rotation(const double *upp_tr, double *out); + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); bigint last_negative; }; From 61b12a09f2c3f81e520aa788721985f762d50ced Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 08:01:11 +0000 Subject: [PATCH 010/557] added lbfgs --- src/SPIN/min_spin_oso_lbfgs.cpp | 577 ++++++++++++++++++++++++++++++++ src/SPIN/min_spin_oso_lbfgs.h | 73 ++++ 2 files changed, 650 insertions(+) create mode 100644 src/SPIN/min_spin_oso_lbfgs.cpp create mode 100644 src/SPIN/min_spin_oso_lbfgs.h diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp new file mode 100644 index 0000000000..f0a4fcbd87 --- /dev/null +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -0,0 +1,577 @@ +/* ---------------------------------------------------------------------- + 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: Aleksei Ivanov (UI) + Julien Tranchida (SNL) + + Please cite the related publication: + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + preprint arXiv:1904.02669. +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +#include "min_spin_oso_lbfgs.h" +#include "universe.h" +#include "atom.h" +#include "citeme.h" +#include "force.h" +#include "update.h" +#include "output.h" +#include "timer.h" +#include "error.h" +#include "modify.h" +#include "math_special.h" +#include "math_const.h" + +#include +using namespace std; + +using namespace LAMMPS_NS; +using namespace MathConst; + +static const char cite_minstyle_spin_oso_lbfgs[] = + "min_style spin/oso_lbfgs command:\n\n" + "@article{ivanov2019fast,\n" + "title={Fast and Robust Algorithm for the Minimisation of the Energy of " + "Spin Systems},\n" + "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" + "journal={arXiv preprint arXiv:1904.02669},\n" + "year={2019}\n" + "}\n\n"; + +// EPS_ENERGY = minimum normalization for energy tolerance + +#define EPS_ENERGY 1.0e-8 + +#define DELAYSTEP 5 + + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : Min(lmp) { + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::init() +{ + alpha_damp = 1.0; + discrete_factor = 10.0; + num_mem = 3; + + Min::init(); + + dts = dt = update->dt; + last_negative = update->ntimestep; +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::setup_style() +{ + double **v = atom->v; + int nlocal = atom->nlocal; + + // check if the atom/spin style is defined + + if (!atom->sp_flag) + error->all(FLERR,"min/spin_oso_lbfgs requires atom/spin style"); + + for (int i = 0; i < nlocal; i++) + v[i][0] = v[i][1] = v[i][2] = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) +{ + if (strcmp(arg[0],"alpha_damp") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + alpha_damp = force->numeric(FLERR,arg[1]); + return 2; + } + if (strcmp(arg[0],"discrete_factor") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + discrete_factor = force->numeric(FLERR,arg[1]); + return 2; + } + return 0; +} + +/* ---------------------------------------------------------------------- + set current vector lengths and pointers + called after atoms have migrated +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::reset_vectors() +{ + // atomic dof + + // size sp is 4N vector + nvec = 4 * atom->nlocal; + if (nvec) spvec = atom->sp[0]; + + nvec = 3 * atom->nlocal; + if (nvec) fmvec = atom->fm[0]; + + if (nvec) xvec = atom->x[0]; + if (nvec) fvec = atom->f[0]; +} + +/* ---------------------------------------------------------------------- + minimization via damped spin dynamics +------------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS::iterate(int maxiter) +{ + bigint ntimestep; + double fmdotfm; + int flag, flagall; + + // not sure it is best place to allocate memory + int nlocal = atom->nlocal; + g = (double *) calloc(3*nlocal, sizeof(double)); + p = (double *) calloc(3*nlocal, sizeof(double)); + g_old = (double *) calloc(3*nlocal, sizeof(double)); + rho = (double *) calloc(num_mem, sizeof(double)); + ds = (double **) calloc(num_mem, sizeof(double *)); + dy = (double **) calloc(num_mem, sizeof(double *)); + for (int k = 0; k < num_mem; k++){ + ds[k] = (double *) calloc(3*nlocal, sizeof(double)); + dy[k] = (double *) calloc(3*nlocal, sizeof(double)); + } + + for (int iter = 0; iter < maxiter; iter++) { + + if (timer->check_timeout(niter)) + return TIMEOUT; + + ntimestep = ++update->ntimestep; + niter++; + + // optimize timestep accross processes / replicas + // need a force calculation for timestep optimization + + energy_force(0); + // dts = evaluate_dt(); + // dts = 1.0; + calc_gradient(1.0); + calc_search_direction(iter); + advance_spins(); + + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + + //// energy tolerance criterion + //// only check after DELAYSTEP elapsed since velocties reset to 0 + //// sync across replicas if running multi-replica minimization + + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { + if (update->multireplica == 0) { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + return ETOL; + } else { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return ETOL; + } + } + + // magnetic torque tolerance criterion + // sync across replicas if running multi-replica minimization + + if (update->ftol > 0.0) { + fmdotfm = fmnorm_sqr(); + if (update->multireplica == 0) { + if (fmdotfm < update->ftol*update->ftol) return FTOL; + } else { + if (fmdotfm < update->ftol*update->ftol) flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return FTOL; + } + } + + // output for thermo, dump, restart files + + if (output->next == ntimestep) { + timer->stamp(); + output->write(ntimestep); + timer->stamp(Timer::OUTPUT); + } + } + + free(p); + free(g); + free(g_old); + for (int k = 0; k < num_mem; k++){ + free(ds[k]); + free(dy[k]); + } + free(ds); + free(dy); + free(rho); + + return MAXITER; +} + +/* ---------------------------------------------------------------------- + evaluate max timestep +---------------------------------------------------------------------- */ + +double MinSpinOSO_LBFGS::evaluate_dt() +{ + double dtmax; + double fmsq; + double fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + double **fm = atom->fm; + + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + if (fmaxsqall == 0.0) + error->all(FLERR,"Incorrect fmaxsqall calculation"); + + // define max timestep by dividing by the + // inverse of max frequency by discrete_factor + + dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); + + return dtmax; +} + +/* ---------------------------------------------------------------------- + calculate gradients +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::calc_gradient(double dts) +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + + // calc. damping torque + + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + // calculate gradients + + g[3 * i + 0] = -tdampz * dts; + g[3 * i + 1] = tdampy * dts; + g[3 * i + 2] = -tdampx * dts; + } +} + +/* ---------------------------------------------------------------------- + search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::calc_search_direction(int iter) +{ + int nlocal = atom->nlocal; + + double dyds = 0.0; + double sq = 0.0; + double yy = 0.0; + double yr = 0.0; + double beta = 0.0; + + double dyds_global = 0.0; + double sq_global = 0.0; + double yy_global = 0.0; + double yr_global = 0.0; + double beta_global = 0.0; + + int m_index = iter % num_mem; // memory index + int c_ind = 0; + double *q; + double *alpha; + + q = (double *) calloc(3*nlocal, sizeof(double)); + alpha = (double *) calloc(num_mem, sizeof(double)); + + // for some reason on a second iteration g_old = 0 + // so we make two iterations as steepest descent + + if (iter == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p[i] = -g[i]; + g_old[i] = g[i]; + ds[m_index][i] = 0.0; + dy[m_index][i] = 0.0; + + } + } else { + dyds = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + ds[m_index][i] = p[i]; + dy[m_index][i] = g[i] - g_old[i]; + dyds += ds[m_index][i] * dy[m_index][i]; + } +// MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds; + else rho[m_index] = 1.0e60; + + // set the q vector + + for (int i = 0; i < 3 * nlocal; i++) { + q[i] = g[i]; + } + + // loop over last m indecies + for(int k = num_mem - 1; k > -1; k--) { + // this loop should run from the newest memory to the oldest one. + + c_ind = (k + m_index + 1) % num_mem; + + // dot product between dg and q + + sq = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + sq += ds[c_ind][i] * q[i]; + } + + // update alpha + + alpha[c_ind] = rho[c_ind] * sq; + + // update q + + for (int i = 0; i < 3 * nlocal; i++) { + q[i] -= alpha[c_ind] * dy[c_ind][i]; + } + } + + // dot product between dg with itself + yy = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + yy += dy[m_index][i] * dy[m_index][i]; + } + + // calculate now search direction + + if (fabs(yy) > 1.0e-60) { + for (int i = 0; i < 3 * nlocal; i++) { + p[i] = q[i] / (rho[m_index] * yy); + } + }else{ + for (int i = 0; i < 3 * nlocal; i++) { + p[i] = q[i] * 1.0e60; + } + } + + for (int k = 0; k < num_mem; k++){ + // this loop should run from the oldest memory to the newest one. + + if (iter < num_mem) c_ind = k; + else c_ind = (k + m_index + 1) % num_mem; + + // dot product between p and da + yr = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + yr += dy[c_ind][i] * p[i]; + } + + beta = rho[c_ind] * yr; + for (int i = 0; i < 3 * nlocal; i++) { + p[i] += ds[c_ind][i] * (alpha[c_ind] - beta); + } + } + for (int i = 0; i < 3 * nlocal; i++) { + p[i] = -1.0 * p[i]; + g_old[i] = g[i]; + } + } + + free(q); + free(alpha); + +} + +/* ---------------------------------------------------------------------- + rotation of spins along the search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::advance_spins() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + rodrigues_rotation(p + 3 * i, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + sp[i][0] = s_new[0]; + sp[i][1] = s_new[1]; + sp[i][2] = s_new[2]; + } +} + +/* ---------------------------------------------------------------------- + compute and return ||mag. torque||_2^2 +------------------------------------------------------------------------- */ + +double MinSpinOSO_LBFGS::fmnorm_sqr() +{ + int nlocal = atom->nlocal; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + // calc. magnetic torques + + double local_norm2_sqr = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + local_norm2_sqr += tx*tx + ty*ty + tz*tz; + } + + // no extra atom calc. for spins + + if (nextra_atom) + error->all(FLERR,"extra atom option not available yet"); + + double norm2_sqr = 0.0; + MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); + + return norm2_sqr; +} + +/* ---------------------------------------------------------------------- + calculate 3x3 matrix exponential using Rodrigues' formula + (R. Murray, Z. Li, and S. Shankar Sastry, + A Mathematical Introduction to + Robotic Manipulation (1994), p. 28 and 30). + + upp_tr - vector x, y, z so that one calculate + U = exp(A) with A= [[0, x, y], + [-x, 0, z], + [-y, -z, 0]] +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) +{ + + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + + // if upp_tr is zero, return unity matrix + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } + } + return; + } + + double theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); + + double A = cos(theta); + double B = sin(theta); + double D = 1 - A; + double x = upp_tr[0]/theta; + double y = upp_tr[1]/theta; + double z = upp_tr[2]/theta; + + // diagonal elements of U + + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; + + // off diagonal of U + + double s1 = -y * z *D; + double s2 = x * z * D; + double s3 = -x * y * D; + + double a1 = x * B; + double a2 = y * B; + double a3 = z * B; + + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; + +} + +/* ---------------------------------------------------------------------- + out = vector^T x m, + m -- 3x3 matrix , v -- 3-d vector +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) +{ + for(int i = 0; i < 3; i++){ + out[i] *= 0.0; + for(int j = 0; j < 3; j++){ + out[i] += *(m + 3 * j + i) * v[j]; + } + } +} diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h new file mode 100644 index 0000000000..0a06824382 --- /dev/null +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -0,0 +1,73 @@ +/* -*- 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 MINIMIZE_CLASS + +MinimizeStyle(spin/oso_lbfgs, MinSpinOSO_LBFGS) + +#else + +#ifndef LMP_MIN_SPIN_OSO_LBFGS_H +#define LMP_MIN_SPIN_OSO_LBFGS_H + +#include "min.h" + +namespace LAMMPS_NS { + +class MinSpinOSO_LBFGS : public Min { + +public: + MinSpinOSO_LBFGS(class LAMMPS *); + ~MinSpinOSO_LBFGS() {} + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); + double evaluate_dt(); + void advance_spins(); + double fmnorm_sqr(); + void calc_gradient(double); + void calc_search_direction(int); + +private: + // global and spin timesteps + + double dt; + double dts; + + double alpha_damp; // damping for spin minimization + double discrete_factor; // factor for spin timestep evaluation + + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + + double *g; // gradient vector + double *g_old; // gradient vector at previous step + double *p; // search direction vector + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double *rho; // estimation of curvature + int num_mem; // number of stored steps + + + void vm3(const double *m, const double *v, double *out); + void rodrigues_rotation(const double *upp_tr, double *out); + + bigint last_negative; +}; + +} + +#endif +#endif From 89ecd5d9f9e3daa9fb62430a883e896c3c5235e1 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 08:35:41 +0000 Subject: [PATCH 011/557] get rid off double loops in cg --- src/SPIN/min_spin_oso_cg.cpp | 30 +++++++++++------------------- 1 file changed, 11 insertions(+), 19 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index d6bca32a40..0c628f7567 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -329,19 +329,15 @@ void MinSpinOSO_CG::calc_search_direction(int iter) // for some reason on a second iteration g_old = 0 // so we make two iterations as steepest descent - if (iter <= 2 || iter % 5 == 0){ // steepest descent direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p_s[3 * i + j] = -g_cur[3 * i + j]; - g_old[3 * i + j] = g_cur[3 * i + j]; - } + if (iter == 0 || iter % 5 == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i]; + g_old[i] = g_cur[i]; } } else { // conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - g2old += g_old[3 * i + j] * g_old[3 * i + j]; - g2 += g_cur[3 * i + j] * g_cur[3 * i + j]; - } + for (int i = 0; i < 3 * nlocal; i++) { + g2old += g_old[i] * g_old[i]; + g2 += g_cur[i] * g_cur[i]; } // now we need to collect/broadcast beta on this replica @@ -355,11 +351,9 @@ void MinSpinOSO_CG::calc_search_direction(int iter) // calculate conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p_s[3 * i + j] = beta * p_s[3 * i + j] - g_cur[3 * i + j]; - g_old[3 * i + j] = g_cur[3 * i + j]; - } + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = beta * p_s[i] - g_cur[i]; + g_old[i] = g_cur[i]; } } } @@ -385,9 +379,7 @@ void MinSpinOSO_CG::advance_spins() // rotate spins vm3(rot_mat, sp[i], s_new); - sp[i][0] = s_new[0]; - sp[i][1] = s_new[1]; - sp[i][2] = s_new[2]; + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; } } From 0f2997533a258ca0869c57ca3c67b309b1d538d7 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 08:36:44 +0000 Subject: [PATCH 012/557] get rid off double loops in cg --- src/SPIN/min_spin_oso_cg.cpp | 29 ++++++++++------------------- 1 file changed, 10 insertions(+), 19 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index d6bca32a40..5ea5ad8b6d 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -326,22 +326,15 @@ void MinSpinOSO_CG::calc_search_direction(int iter) double g2_global= 0.0; double g2old_global= 0.0; - // for some reason on a second iteration g_old = 0 - // so we make two iterations as steepest descent - - if (iter <= 2 || iter % 5 == 0){ // steepest descent direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p_s[3 * i + j] = -g_cur[3 * i + j]; - g_old[3 * i + j] = g_cur[3 * i + j]; - } + if (iter == 0 || iter % 5 == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i]; + g_old[i] = g_cur[i]; } } else { // conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - g2old += g_old[3 * i + j] * g_old[3 * i + j]; - g2 += g_cur[3 * i + j] * g_cur[3 * i + j]; - } + for (int i = 0; i < 3 * nlocal; i++) { + g2old += g_old[i] * g_old[i]; + g2 += g_cur[i] * g_cur[i]; } // now we need to collect/broadcast beta on this replica @@ -355,11 +348,9 @@ void MinSpinOSO_CG::calc_search_direction(int iter) // calculate conjugate direction - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++){ - p_s[3 * i + j] = beta * p_s[3 * i + j] - g_cur[3 * i + j]; - g_old[3 * i + j] = g_cur[3 * i + j]; - } + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = beta * p_s[i] - g_cur[i]; + g_old[i] = g_cur[i]; } } } From 5f74f6ddfa9aac318a00c17e1afd59f5d3438f15 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 08:38:44 +0000 Subject: [PATCH 013/557] delete irrelevant comment --- src/SPIN/min_spin_oso_cg.cpp | 3 --- 1 file changed, 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 0c628f7567..4449832f54 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -326,9 +326,6 @@ void MinSpinOSO_CG::calc_search_direction(int iter) double g2_global= 0.0; double g2old_global= 0.0; - // for some reason on a second iteration g_old = 0 - // so we make two iterations as steepest descent - if (iter == 0 || iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i]; From 6a2a4d5cfb00c51de71e4f59288a73b739cb2da9 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 08:58:31 +0000 Subject: [PATCH 014/557] parallelisation of lbfgs --- src/SPIN/min_spin_oso_lbfgs.cpp | 23 +++++++++++++---------- 1 file changed, 13 insertions(+), 10 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index f0a4fcbd87..f21245899b 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -356,8 +356,8 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) dy[m_index][i] = g[i] - g_old[i]; dyds += ds[m_index][i] * dy[m_index][i]; } -// MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); - if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds; + MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; // set the q vector @@ -378,10 +378,11 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) for (int i = 0; i < 3 * nlocal; i++) { sq += ds[c_ind][i] * q[i]; } + MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); // update alpha - alpha[c_ind] = rho[c_ind] * sq; + alpha[c_ind] = rho[c_ind] * sq_global; // update q @@ -395,12 +396,13 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) for (int i = 0; i < 3 * nlocal; i++) { yy += dy[m_index][i] * dy[m_index][i]; } + MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); - // calculate now search direction + // calculate now search direction - if (fabs(yy) > 1.0e-60) { + if (fabs(yy_global) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { - p[i] = q[i] / (rho[m_index] * yy); + p[i] = q[i] / (rho[m_index] * yy_global); } }else{ for (int i = 0; i < 3 * nlocal; i++) { @@ -419,8 +421,9 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) for (int i = 0; i < 3 * nlocal; i++) { yr += dy[c_ind][i] * p[i]; } + MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); - beta = rho[c_ind] * yr; + beta = rho[c_ind] * yr_global; for (int i = 0; i < 3 * nlocal; i++) { p[i] += ds[c_ind][i] * (alpha[c_ind] - beta); } @@ -514,7 +517,7 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) if (fabs(upp_tr[0]) < 1.0e-40 && fabs(upp_tr[1]) < 1.0e-40 && fabs(upp_tr[2]) < 1.0e-40){ - + // if upp_tr is zero, return unity matrix for(int k = 0; k < 3; k++){ for(int m = 0; m < 3; m++){ @@ -537,13 +540,13 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) double z = upp_tr[2]/theta; // diagonal elements of U - + out[0] = A + z * z * D; out[4] = A + y * y * D; out[8] = A + x * x * D; // off diagonal of U - + double s1 = -y * z *D; double s2 = x * z * D; double s3 = -x * y * D; From 0a0e85ac46b335e0df5242ee1b635a39adddc1a1 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 09:03:17 +0000 Subject: [PATCH 015/557] rodr. rot. as in cg --- src/SPIN/min_spin_oso_lbfgs.cpp | 38 +++++++++++++++++---------------- 1 file changed, 20 insertions(+), 18 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index f21245899b..d200e07f4a 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -513,6 +513,8 @@ double MinSpinOSO_LBFGS::fmnorm_sqr() void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) { + double theta,A,B,D,x,y,z; + double s1,s2,s3,a1,a2,a3; if (fabs(upp_tr[0]) < 1.0e-40 && fabs(upp_tr[1]) < 1.0e-40 && @@ -521,23 +523,23 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) // if upp_tr is zero, return unity matrix for(int k = 0; k < 3; k++){ for(int m = 0; m < 3; m++){ - if (m == k) out[3 * k + m] = 1.0; - else out[3 * k + m] = 0.0; - } + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } } return; } - double theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); + theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); - double A = cos(theta); - double B = sin(theta); - double D = 1 - A; - double x = upp_tr[0]/theta; - double y = upp_tr[1]/theta; - double z = upp_tr[2]/theta; + A = cos(theta); + B = sin(theta); + D = 1 - A; + x = upp_tr[0]/theta; + y = upp_tr[1]/theta; + z = upp_tr[2]/theta; // diagonal elements of U @@ -547,13 +549,13 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) // off diagonal of U - double s1 = -y * z *D; - double s2 = x * z * D; - double s3 = -x * y * D; + s1 = -y * z *D; + s2 = x * z * D; + s3 = -x * y * D; - double a1 = x * B; - double a2 = y * B; - double a3 = z * B; + a1 = x * B; + a2 = y * B; + a3 = z * B; out[1] = s1 + a1; out[3] = s1 - a1; From 1d64d78f240b3bc8a26872ba1cb78b5a83772b45 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 09:40:14 +0000 Subject: [PATCH 016/557] handle memory in a right way --- src/SPIN/min_spin_oso_lbfgs.cpp | 93 ++++++++++++++++++--------------- 1 file changed, 52 insertions(+), 41 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index d200e07f4a..1143786d73 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -34,13 +34,11 @@ #include "output.h" #include "timer.h" #include "error.h" +#include "memory.h" #include "modify.h" #include "math_special.h" #include "math_const.h" -#include -using namespace std; - using namespace LAMMPS_NS; using namespace MathConst; @@ -63,8 +61,23 @@ static const char cite_minstyle_spin_oso_lbfgs[] = /* ---------------------------------------------------------------------- */ -MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : Min(lmp) { +MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL) +{ if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); + nlocal_max = 0; +} + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_LBFGS::~MinSpinOSO_LBFGS() +{ + memory->destroy(g_old); + memory->destroy(g_cur); + memory->destroy(p_s); + memory->destroy(ds); + memory->destroy(dy); + memory->destroy(rho); } /* ---------------------------------------------------------------------- */ @@ -79,6 +92,17 @@ void MinSpinOSO_LBFGS::init() dts = dt = update->dt; last_negative = update->ntimestep; + + // allocate tables + + nlocal_max = atom->nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs:p_s"); + memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); + } /* ---------------------------------------------------------------------- */ @@ -140,21 +164,19 @@ void MinSpinOSO_LBFGS::reset_vectors() int MinSpinOSO_LBFGS::iterate(int maxiter) { + int nlocal = atom->nlocal; bigint ntimestep; double fmdotfm; int flag, flagall; - // not sure it is best place to allocate memory - int nlocal = atom->nlocal; - g = (double *) calloc(3*nlocal, sizeof(double)); - p = (double *) calloc(3*nlocal, sizeof(double)); - g_old = (double *) calloc(3*nlocal, sizeof(double)); - rho = (double *) calloc(num_mem, sizeof(double)); - ds = (double **) calloc(num_mem, sizeof(double *)); - dy = (double **) calloc(num_mem, sizeof(double *)); - for (int k = 0; k < num_mem; k++){ - ds[k] = (double *) calloc(3*nlocal, sizeof(double)); - dy[k] = (double *) calloc(3*nlocal, sizeof(double)); + if (nlocal_max < nlocal) { + nlocal_max = nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); } for (int iter = 0; iter < maxiter; iter++) { @@ -222,17 +244,6 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) } } - free(p); - free(g); - free(g_old); - for (int k = 0; k < num_mem; k++){ - free(ds[k]); - free(dy[k]); - } - free(ds); - free(dy); - free(rho); - return MAXITER; } @@ -304,9 +315,9 @@ void MinSpinOSO_LBFGS::calc_gradient(double dts) // calculate gradients - g[3 * i + 0] = -tdampz * dts; - g[3 * i + 1] = tdampy * dts; - g[3 * i + 2] = -tdampx * dts; + g_cur[3 * i + 0] = -tdampz * dts; + g_cur[3 * i + 1] = tdampy * dts; + g_cur[3 * i + 2] = -tdampx * dts; } } @@ -343,8 +354,8 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) if (iter == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { - p[i] = -g[i]; - g_old[i] = g[i]; + p_s[i] = -g_cur[i]; + g_old[i] = g_cur[i]; ds[m_index][i] = 0.0; dy[m_index][i] = 0.0; @@ -352,8 +363,8 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) } else { dyds = 0.0; for (int i = 0; i < 3 * nlocal; i++) { - ds[m_index][i] = p[i]; - dy[m_index][i] = g[i] - g_old[i]; + ds[m_index][i] = p_s[i]; + dy[m_index][i] = g_cur[i] - g_old[i]; dyds += ds[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); @@ -363,7 +374,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) // set the q vector for (int i = 0; i < 3 * nlocal; i++) { - q[i] = g[i]; + q[i] = g_cur[i]; } // loop over last m indecies @@ -402,11 +413,11 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) if (fabs(yy_global) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { - p[i] = q[i] / (rho[m_index] * yy_global); + p_s[i] = q[i] / (rho[m_index] * yy_global); } }else{ for (int i = 0; i < 3 * nlocal; i++) { - p[i] = q[i] * 1.0e60; + p_s[i] = q[i] * 1.0e60; } } @@ -419,18 +430,18 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) // dot product between p and da yr = 0.0; for (int i = 0; i < 3 * nlocal; i++) { - yr += dy[c_ind][i] * p[i]; + yr += dy[c_ind][i] * p_s[i]; } MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); beta = rho[c_ind] * yr_global; for (int i = 0; i < 3 * nlocal; i++) { - p[i] += ds[c_ind][i] * (alpha[c_ind] - beta); + p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); } } for (int i = 0; i < 3 * nlocal; i++) { - p[i] = -1.0 * p[i]; - g_old[i] = g[i]; + p_s[i] = -1.0 * p_s[i]; + g_old[i] = g_cur[i]; } } @@ -455,7 +466,7 @@ void MinSpinOSO_LBFGS::advance_spins() // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p + 3 * i, rot_mat); + rodrigues_rotation(p_s + 3 * i, rot_mat); // rotate spins From 56c34e42670b7b2c079d462e480f17afe4508cb1 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 09:41:34 +0000 Subject: [PATCH 017/557] merge memory alloc for lbfgs --- src/SPIN/min_spin_oso_lbfgs.h | 7 ++++--- 1 file changed, 4 insertions(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 0a06824382..3aa326142c 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -28,7 +28,7 @@ class MinSpinOSO_LBFGS : public Min { public: MinSpinOSO_LBFGS(class LAMMPS *); - ~MinSpinOSO_LBFGS() {} + virtual ~MinSpinOSO_LBFGS(); void init(); void setup_style(); int modify_param(int, char **); @@ -43,6 +43,7 @@ public: private: // global and spin timesteps + int nlocal_max; // max value of nlocal (for size of lists) double dt; double dts; @@ -52,9 +53,9 @@ private: double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector - double *g; // gradient vector + double *g_cur; // current gradient vector double *g_old; // gradient vector at previous step - double *p; // search direction vector + double *p_s; // search direction vector double **ds; // change in rotation matrix between two iterations, da double **dy; // change in gradients between two iterations, dg double *rho; // estimation of curvature From 924c610ebe69ae10656cd9ba70cc05f2723c900f Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 1 Jul 2019 09:45:05 +0000 Subject: [PATCH 018/557] use for loop --- src/SPIN/min_spin_oso_lbfgs.cpp | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 1143786d73..f3643168a4 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -471,9 +471,7 @@ void MinSpinOSO_LBFGS::advance_spins() // rotate spins vm3(rot_mat, sp[i], s_new); - sp[i][0] = s_new[0]; - sp[i][1] = s_new[1]; - sp[i][2] = s_new[2]; + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; } } From 398f33d4072576e9237744f95709982c1e6c895a Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 2 Jul 2019 16:36:06 +0000 Subject: [PATCH 019/557] added cubic line search --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 717 +++++++++++++++++++++++++++++ src/SPIN/min_spin_oso_lbfgs_ls.h | 84 ++++ 2 files changed, 801 insertions(+) create mode 100644 src/SPIN/min_spin_oso_lbfgs_ls.cpp create mode 100644 src/SPIN/min_spin_oso_lbfgs_ls.h diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp new file mode 100644 index 0000000000..f054755129 --- /dev/null +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -0,0 +1,717 @@ +/* ---------------------------------------------------------------------- + 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: Aleksei Ivanov (UI) + Julien Tranchida (SNL) + + Please cite the related publication: + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + preprint arXiv:1904.02669. +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +#include "min_spin_oso_lbfgs_ls.h" +#include "universe.h" +#include "atom.h" +#include "citeme.h" +#include "force.h" +#include "update.h" +#include "output.h" +#include "timer.h" +#include "error.h" +#include "memory.h" +#include "modify.h" +#include "math_special.h" +#include "math_const.h" +#include + + +using namespace LAMMPS_NS; +using namespace MathConst; + +static const char cite_minstyle_spin_oso_lbfgs_ls[] = + "min_style spin/oso_lbfgs_ls command:\n\n" + "@article{ivanov2019fast,\n" + "title={Fast and Robust Algorithm for the Minimisation of the Energy of " + "Spin Systems},\n" + "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" + "journal={arXiv preprint arXiv:1904.02669},\n" + "year={2019}\n" + "}\n\n"; + +// EPS_ENERGY = minimum normalization for energy tolerance + +#define EPS_ENERGY 1.0e-8 + +#define DELAYSTEP 5 + + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL) +{ + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs_ls); + nlocal_max = 0; +} + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_LBFGS_LS::~MinSpinOSO_LBFGS_LS() +{ + memory->destroy(g_old); + memory->destroy(g_cur); + memory->destroy(p_s); + memory->destroy(ds); + memory->destroy(dy); + memory->destroy(rho); + memory->destroy(sp_copy); +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::init() +{ + alpha_damp = 1.0; + discrete_factor = 10.0; + num_mem = 3; + der_e_cur = 0.0; + der_e_pr = 0.0; + use_line_search = 1; + + Min::init(); + + dts = dt = update->dt; + last_negative = update->ntimestep; + + // allocate tables + + nlocal_max = atom->nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs_ls:p_s"); + memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); + +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::setup_style() +{ + double **v = atom->v; + int nlocal = atom->nlocal; + + // check if the atom/spin style is defined + + if (!atom->sp_flag) + error->all(FLERR,"min/spin_oso_lbfgs_ls requires atom/spin style"); + + for (int i = 0; i < nlocal; i++) + v[i][0] = v[i][1] = v[i][2] = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS_LS::modify_param(int narg, char **arg) +{ + if (strcmp(arg[0],"alpha_damp") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + alpha_damp = force->numeric(FLERR,arg[1]); + return 2; + } + if (strcmp(arg[0],"discrete_factor") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + discrete_factor = force->numeric(FLERR,arg[1]); + return 2; + } + return 0; +} + +/* ---------------------------------------------------------------------- + set current vector lengths and pointers + called after atoms have migrated +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::reset_vectors() +{ + // atomic dof + + // size sp is 4N vector + nvec = 4 * atom->nlocal; + if (nvec) spvec = atom->sp[0]; + + nvec = 3 * atom->nlocal; + if (nvec) fmvec = atom->fm[0]; + + if (nvec) xvec = atom->x[0]; + if (nvec) fvec = atom->f[0]; +} + +/* ---------------------------------------------------------------------- + minimization via damped spin dynamics +------------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS_LS::iterate(int maxiter) +{ + int nlocal = atom->nlocal; + bigint ntimestep; + double fmdotfm; + int flag, flagall; + double **sp = atom->sp; + + if (nlocal_max < nlocal) { + nlocal_max = nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs_ls:p_s"); + memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); + } + + + for (int iter = 0; iter < maxiter; iter++) { + + if (timer->check_timeout(niter)) + return TIMEOUT; + + ntimestep = ++update->ntimestep; + niter++; + + // optimize timestep accross processes / replicas + // need a force calculation for timestep optimization + + if (iter == 0){ + ecurrent = energy_force(0); + calc_gradient(1.0); + neval++; + }else{ + } + calc_search_direction(iter); + + if (use_line_search) { + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + } + + if (use_line_search){ + // here we need to do line search + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp_copy[i][j] = sp[i][j]; + } + eprevious = ecurrent; + der_e_pr = der_e_cur; + + calc_and_make_step(0.0, 1.0, 0); + } + else{ + advance_spins(); + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + } + + //// energy tolerance criterion + //// only check after DELAYSTEP elapsed since velocties reset to 0 + //// sync across replicas if running multi-replica minimization + + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { + if (update->multireplica == 0) { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + return ETOL; + } else { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return ETOL; + } + } + + // magnetic torque tolerance criterion + // sync across replicas if running multi-replica minimization + + if (update->ftol > 0.0) { + fmdotfm = fmnorm_sqr(); + if (update->multireplica == 0) { + if (fmdotfm < update->ftol*update->ftol) return FTOL; + } else { + if (fmdotfm < update->ftol*update->ftol) flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return FTOL; + } + } + + // output for thermo, dump, restart files + + if (output->next == ntimestep) { + timer->stamp(); + output->write(ntimestep); + timer->stamp(Timer::OUTPUT); + } + } + + return MAXITER; +} + +/* ---------------------------------------------------------------------- + evaluate max timestep +---------------------------------------------------------------------- */ + +double MinSpinOSO_LBFGS_LS::evaluate_dt() +{ + double dtmax; + double fmsq; + double fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + double **fm = atom->fm; + + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + if (fmaxsqall == 0.0) + error->all(FLERR,"Incorrect fmaxsqall calculation"); + + // define max timestep by dividing by the + // inverse of max frequency by discrete_factor + + dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); + + return dtmax; +} + +/* ---------------------------------------------------------------------- + calculate gradients +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::calc_gradient(double dts) +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + + // calc. damping torque + + tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + // calculate gradients + + g_cur[3 * i + 0] = -tdampz * dts; + g_cur[3 * i + 1] = tdampy * dts; + g_cur[3 * i + 2] = -tdampx * dts; + } +} + +/* ---------------------------------------------------------------------- + search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) +{ + int nlocal = atom->nlocal; + + double dyds = 0.0; + double sq = 0.0; + double yy = 0.0; + double yr = 0.0; + double beta = 0.0; + + double dyds_global = 0.0; + double sq_global = 0.0; + double yy_global = 0.0; + double yr_global = 0.0; + double beta_global = 0.0; + + int m_index = iter % num_mem; // memory index + int c_ind = 0; + double *q; + double *alpha; + + q = (double *) calloc(3*nlocal, sizeof(double)); + alpha = (double *) calloc(num_mem, sizeof(double)); + + // for some reason on a second iteration g_old = 0 + // so we make two iterations as steepest descent + + if (iter == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i]; + g_old[i] = g_cur[i]; + ds[m_index][i] = 0.0; + dy[m_index][i] = 0.0; + + } + } else { + dyds = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + ds[m_index][i] = p_s[i]; + dy[m_index][i] = g_cur[i] - g_old[i]; + dyds += ds[m_index][i] * dy[m_index][i]; + } + MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; + else rho[m_index] = 1.0e60; + + // set the q vector + + for (int i = 0; i < 3 * nlocal; i++) { + q[i] = g_cur[i]; + } + + // loop over last m indecies + for(int k = num_mem - 1; k > -1; k--) { + // this loop should run from the newest memory to the oldest one. + + c_ind = (k + m_index + 1) % num_mem; + + // dot product between dg and q + + sq = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + sq += ds[c_ind][i] * q[i]; + } + MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); + + // update alpha + + alpha[c_ind] = rho[c_ind] * sq_global; + + // update q + + for (int i = 0; i < 3 * nlocal; i++) { + q[i] -= alpha[c_ind] * dy[c_ind][i]; + } + } + + // dot product between dg with itself + yy = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + yy += dy[m_index][i] * dy[m_index][i]; + } + MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); + + // calculate now search direction + + if (fabs(yy_global) > 1.0e-60) { + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = q[i] / (rho[m_index] * yy_global); + } + }else{ + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = q[i] * 1.0e60; + } + } + + for (int k = 0; k < num_mem; k++){ + // this loop should run from the oldest memory to the newest one. + + if (iter < num_mem) c_ind = k; + else c_ind = (k + m_index + 1) % num_mem; + + // dot product between p and da + yr = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + yr += dy[c_ind][i] * p_s[i]; + } + MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); + + beta = rho[c_ind] * yr_global; + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); + } + } + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -1.0 * p_s[i]; + g_old[i] = g_cur[i]; + } + } + + free(q); + free(alpha); + +} + +/* ---------------------------------------------------------------------- + rotation of spins along the search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::advance_spins() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + rodrigues_rotation(p_s + 3 * i, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } +} + +/* ---------------------------------------------------------------------- + compute and return ||mag. torque||_2^2 +------------------------------------------------------------------------- */ + +double MinSpinOSO_LBFGS_LS::fmnorm_sqr() +{ + int nlocal = atom->nlocal; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + // calc. magnetic torques + + double local_norm2_sqr = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + + local_norm2_sqr += tx*tx + ty*ty + tz*tz; + } + + // no extra atom calc. for spins + + if (nextra_atom) + error->all(FLERR,"extra atom option not available yet"); + + double norm2_sqr = 0.0; + MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); + + return norm2_sqr; +} + +/* ---------------------------------------------------------------------- + calculate 3x3 matrix exponential using Rodrigues' formula + (R. Murray, Z. Li, and S. Shankar Sastry, + A Mathematical Introduction to + Robotic Manipulation (1994), p. 28 and 30). + + upp_tr - vector x, y, z so that one calculate + U = exp(A) with A= [[0, x, y], + [-x, 0, z], + [-y, -z, 0]] +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::rodrigues_rotation(const double *upp_tr, double *out) +{ + double theta,A,B,D,x,y,z; + double s1,s2,s3,a1,a2,a3; + + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + + // if upp_tr is zero, return unity matrix + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } + } + return; + } + + theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); + + A = cos(theta); + B = sin(theta); + D = 1 - A; + x = upp_tr[0]/theta; + y = upp_tr[1]/theta; + z = upp_tr[2]/theta; + + // diagonal elements of U + + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; + + // off diagonal of U + + s1 = -y * z *D; + s2 = x * z * D; + s3 = -x * y * D; + + a1 = x * B; + a2 = y * B; + a3 = z * B; + + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; + +} + +/* ---------------------------------------------------------------------- + out = vector^T x m, + m -- 3x3 matrix , v -- 3-d vector +------------------------------------------------------------------------- */ + +void MinSpinOSO_LBFGS_LS::vm3(const double *m, const double *v, double *out) +{ + for(int i = 0; i < 3; i++){ + out[i] *= 0.0; + for(int j = 0; j < 3; j++){ + out[i] += *(m + 3 * j + i) * v[j]; + } + } +} + + +void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) +{ + double p_scaled[3]; + int nlocal = atom->nlocal; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + double **sp = atom->sp; + + for (int i = 0; i < nlocal; i++) { + + // scale the search direction + + for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; + + // calculate rotation matrix + + rodrigues_rotation(p_scaled, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } + + ecurrent = energy_force(0); + calc_gradient(1.0); + neval++; + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + energy_and_der[0] = ecurrent; + energy_and_der[1] = der_e_cur; +} + + +int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) +{ + double e_and_d[2] = {0.0, 0.0}; + double alpha, c1, c2, c3; + double **sp = atom->sp; + int nlocal = atom->nlocal; + + make_step(b, e_and_d); + ecurrent = e_and_d[0]; + der_e_cur = e_and_d[1]; + index++; + + if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 3){ + + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } + return 1; + } + else{ + double r, f0, f1, df0, df1; + r = b - a; + f0 = eprevious; + f1 = ecurrent; + df0 = der_e_pr; + df1 = der_e_cur; + + c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); + c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); + c3 = df0; + + alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + if (alpha < 0.0) alpha = r/2.0; + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; + } + calc_and_make_step(0.0, alpha, index); + } + + return 0; + +} + + +int MinSpinOSO_LBFGS_LS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ + + double eps = 1.0e-6; + double delta = 0.1; + double sigma = 0.9; + + if ((phi_j <= phi_0 + eps * fabs(phi_0)) && + ((2.0*delta - 1.0) * der_phi_0 >= der_phi_j >= sigma * der_phi_0)) + return 1; + else + return 0; +} diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.h b/src/SPIN/min_spin_oso_lbfgs_ls.h new file mode 100644 index 0000000000..3e0e608ecb --- /dev/null +++ b/src/SPIN/min_spin_oso_lbfgs_ls.h @@ -0,0 +1,84 @@ +/* -*- 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 MINIMIZE_CLASS + +MinimizeStyle(spin/oso_lbfgs_ls, MinSpinOSO_LBFGS_LS) + +#else + +#ifndef LMP_MIN_SPIN_OSO_LBFGS_LS_H +#define LMP_MIN_SPIN_OSO_LBFGS_LS_H + +#include "min.h" + +namespace LAMMPS_NS { + +class MinSpinOSO_LBFGS_LS : public Min { + +public: + MinSpinOSO_LBFGS_LS(class LAMMPS *); + virtual ~MinSpinOSO_LBFGS_LS(); + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); + double evaluate_dt(); + void advance_spins(); + double fmnorm_sqr(); + void calc_gradient(double); + void calc_search_direction(int); + +private: + // global and spin timesteps + + int nlocal_max; // max value of nlocal (for size of lists) + double dt; + double dts; + + double alpha_damp; // damping for spin minimization + double discrete_factor; // factor for spin timestep evaluation + + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + + double *g_cur; // current gradient vector + double *g_old; // gradient vector at previous step + double *p_s; // search direction vector + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double *rho; // estimation of curvature + double **sp_copy; // copy of the spins + + int num_mem; // number of stored steps + + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + + int use_line_search; // use line search or not. + + + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + void make_step(double, double *); + + bigint last_negative; +}; + +} + +#endif +#endif From ee8d3ced31fb88bc0356fd55e52053106495ad0a Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 2 Jul 2019 16:39:27 +0000 Subject: [PATCH 020/557] change cg to lbfgs in oso_lbfgs --- src/SPIN/min_spin_oso_lbfgs.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index f3643168a4..2283a55e51 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -171,9 +171,9 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) if (nlocal_max < nlocal) { nlocal_max = nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs:p_s"); memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); From fd5bc857b24f3d62944c45f0d55542deba473aeb Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 2 Jul 2019 17:03:15 +0000 Subject: [PATCH 021/557] calculate energy in the beginning only once --- src/SPIN/min_spin.cpp | 2 +- src/SPIN/min_spin_oso_cg.cpp | 4 ++-- src/SPIN/min_spin_oso_lbfgs.cpp | 2 +- 3 files changed, 4 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 2bddc110e7..2277281e80 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -133,7 +133,7 @@ int MinSpin::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - energy_force(0); + if (iter == 0) energy_force(0); dts = evaluate_dt(); // apply damped precessional dynamics to the spins diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 4449832f54..9ed2cb96ea 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -180,8 +180,8 @@ int MinSpinOSO_CG::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - - energy_force(0); + + if (iter == 0) energy_force(0); dts = evaluate_dt(); calc_gradient(dts); diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 2283a55e51..b54c42ebfd 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -190,7 +190,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - energy_force(0); + if (iter == 0) energy_force(0); // dts = evaluate_dt(); // dts = 1.0; calc_gradient(1.0); From 44ca54fa25cc90f772c352ee0bfa75bad687a16e Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 2 Jul 2019 17:06:53 +0000 Subject: [PATCH 022/557] a bit more comments --- src/SPIN/min_spin_oso_cg.cpp | 7 +++++-- src/SPIN/min_spin_oso_lbfgs.cpp | 7 +++++-- 2 files changed, 10 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 9ed2cb96ea..8d03ada45d 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing authors: Aleksei Ivanov (UI) + Contributing authors: Aleksei Ivanov (University of Iceland) Julien Tranchida (SNL) Please cite the related publication: @@ -313,7 +313,10 @@ void MinSpinOSO_CG::calc_gradient(double dts) } /* ---------------------------------------------------------------------- - search direction + search direction: + The Fletcher-Reeves conj. grad. method + See Jorge Nocedal and Stephen J. Wright 'Numerical + Optimization' Second Edition, 2006 (p. 121) ---------------------------------------------------------------------- */ void MinSpinOSO_CG::calc_search_direction(int iter) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index b54c42ebfd..81c36d5e32 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing authors: Aleksei Ivanov (UI) + Contributing authors: Aleksei Ivanov (University of Iceland) Julien Tranchida (SNL) Please cite the related publication: @@ -322,7 +322,10 @@ void MinSpinOSO_LBFGS::calc_gradient(double dts) } /* ---------------------------------------------------------------------- - search direction + search direction: + Limited-memory BFGS. + See Jorge Nocedal and Stephen J. Wright 'Numerical + Optimization' Second Edition, 2006 (p. 177) ---------------------------------------------------------------------- */ void MinSpinOSO_LBFGS::calc_search_direction(int iter) From e3ed8d856209b3f7116f82b3077660ad4c2893ba Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 2 Jul 2019 18:02:22 +0000 Subject: [PATCH 023/557] parallelisation of lbfgs, change indentation, more comments --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 140 ++++++++++++++++------------- 1 file changed, 79 insertions(+), 61 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index f054755129..38a557266e 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ------------------------------------------------------------------------ - Contributing authors: Aleksei Ivanov (UI) + Contributing authors: Aleksei Ivanov (University of Iceland) Julien Tranchida (SNL) Please cite the related publication: @@ -176,6 +176,7 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) double fmdotfm; int flag, flagall; double **sp = atom->sp; + double der_e_cur_global = 0.0; if (nlocal_max < nlocal) { nlocal_max = nlocal; @@ -213,6 +214,8 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) for (int i = 0; i < 3 * nlocal; i++) { der_e_cur += g_cur[i] * p_s[i]; } + MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); + der_e_cur = der_e_cur_global; } if (use_line_search){ @@ -353,7 +356,10 @@ void MinSpinOSO_LBFGS_LS::calc_gradient(double dts) } /* ---------------------------------------------------------------------- - search direction + search direction: + Limited-memory BFGS. + See Jorge Nocedal and Stephen J. Wright 'Numerical + Optimization' Second Edition, 2006 (p. 177) ---------------------------------------------------------------------- */ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) @@ -624,26 +630,26 @@ void MinSpinOSO_LBFGS_LS::vm3(const double *m, const double *v, double *out) void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) { - double p_scaled[3]; - int nlocal = atom->nlocal; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - double **sp = atom->sp; + double p_scaled[3]; + int nlocal = atom->nlocal; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + double **sp = atom->sp; + double der_e_cur_global = 0.0;; - for (int i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { + // scale the search direction - // scale the search direction + for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; - for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; + // calculate rotation matrix - // calculate rotation matrix + rodrigues_rotation(p_scaled, rot_mat); - rodrigues_rotation(p_scaled, rot_mat); + // rotate spins - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; } ecurrent = energy_force(0); @@ -653,65 +659,77 @@ void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) for (int i = 0; i < 3 * nlocal; i++) { der_e_cur += g_cur[i] * p_s[i]; } + MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); + der_e_cur = der_e_cur_global; + energy_and_der[0] = ecurrent; energy_and_der[1] = der_e_cur; } +/* ---------------------------------------------------------------------- + Calculate step length which satisfies approximate Wolfe conditions + using the cubic interpolation +------------------------------------------------------------------------- */ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) { - double e_and_d[2] = {0.0, 0.0}; - double alpha, c1, c2, c3; - double **sp = atom->sp; - int nlocal = atom->nlocal; + double e_and_d[2] = {0.0, 0.0}; + double alpha, c1, c2, c3; + double **sp = atom->sp; + int nlocal = atom->nlocal; - make_step(b, e_and_d); - ecurrent = e_and_d[0]; - der_e_cur = e_and_d[1]; - index++; + make_step(b, e_and_d); + ecurrent = e_and_d[0]; + der_e_cur = e_and_d[1]; + index++; - if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 3){ + if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 3){ + MPI_Bcast(&b,1,MPI_DOUBLE,0,world); - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = b * p_s[i]; - } - return 1; + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } + return 1; + } + else{ + double r, f0, f1, df0, df1; + r = b - a; + f0 = eprevious; + f1 = ecurrent; + df0 = der_e_pr; + df1 = der_e_cur; + + c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); + c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); + c3 = df0; + + // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 + // has minimum at alpha below. We do not check boundaries. + + alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + if (alpha < 0.0) alpha = r/2.0; + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; } - else{ - double r, f0, f1, df0, df1; - r = b - a; - f0 = eprevious; - f1 = ecurrent; - df0 = der_e_pr; - df1 = der_e_cur; - - c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); - c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); - c3 = df0; - - alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); - if (alpha < 0.0) alpha = r/2.0; - - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; - } - calc_and_make_step(0.0, alpha, index); - } - - return 0; + calc_and_make_step(0.0, alpha, index); + } + return 0; } - - +/* ---------------------------------------------------------------------- + Approximate Wolfe conditions: + William W. Hager and Hongchao Zhang + SIAM J. optim., 16(1), 170-192. (23 pages) +------------------------------------------------------------------------- */ int MinSpinOSO_LBFGS_LS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ - double eps = 1.0e-6; - double delta = 0.1; - double sigma = 0.9; + double eps = 1.0e-6; + double delta = 0.1; + double sigma = 0.9; - if ((phi_j <= phi_0 + eps * fabs(phi_0)) && - ((2.0*delta - 1.0) * der_phi_0 >= der_phi_j >= sigma * der_phi_0)) - return 1; - else - return 0; + if ((phi_j <= phi_0 + eps * fabs(phi_0)) && ((2.0*delta - 1.0) * der_phi_0 >= der_phi_j >= sigma * der_phi_0)) + return 1; + else + return 0; } From 66a50419734d343a246ab5ce5a91ea327c4f8ab8 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 2 Jul 2019 16:02:36 -0600 Subject: [PATCH 024/557] Commit1 JT 060219 - added all min/spin tests in src/SPIN/neb_spin.cpp - added lbfgs to .gitignore - commit before pull/merge --- src/.gitignore | 2 ++ src/SPIN/min_spin_oso_lbfgs.cpp | 14 +++++++------- src/SPIN/neb_spin.cpp | 5 +++-- 3 files changed, 12 insertions(+), 9 deletions(-) diff --git a/src/.gitignore b/src/.gitignore index 0d802981f9..f0ac3a1ff9 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -163,6 +163,8 @@ /min_spin.h /min_spin_oso_cg.cpp /min_spin_oso_cg.h +/min_spin_oso_lbfgs.cpp +/min_spin_oso_lbfgs.h /neb_spin.cpp /neb_spin.h /pair_spin.cpp diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index f3643168a4..23cb3718c8 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -361,12 +361,12 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) } } else { - dyds = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - ds[m_index][i] = p_s[i]; - dy[m_index][i] = g_cur[i] - g_old[i]; - dyds += ds[m_index][i] * dy[m_index][i]; - } + dyds = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + ds[m_index][i] = p_s[i]; + dy[m_index][i] = g_cur[i] - g_old[i]; + dyds += ds[m_index][i] * dy[m_index][i]; + } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; @@ -409,7 +409,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) } MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); - // calculate now search direction + // calculate now search direction if (fabs(yy_global) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 126cfb09e3..9ab461cbe6 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -50,6 +50,7 @@ #include "memory.h" #include "error.h" #include "math_const.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -194,8 +195,8 @@ void NEBSpin::run() if (update->minimize->searchflag) error->all(FLERR,"NEBSpin requires damped dynamics minimizer"); - if (strcmp(update->minimize_style,"spin") != 0) - error->all(FLERR,"NEBSpin requires spin minimizer"); + if (!utils::strmatch(update->minimize_style,"^spin")) + error->all(FLERR,"NEBSpin requires a spin minimizer"); // setup regular NEBSpin minimization From 8452afb5120c03dfe941afa6a484b98b7e1c5347 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 11:38:31 +0000 Subject: [PATCH 025/557] compare dyds_global instead --- src/SPIN/min_spin_oso_lbfgs.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 83d537030c..e8ac915d8b 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -371,7 +371,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) dyds += ds[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); - if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; + if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; // set the q vector From eaa542b6e78c828756fd83ff82aba113ea36504a Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 11:59:54 +0000 Subject: [PATCH 026/557] scale initial gradients with adaptive time step in the beggining, try to use global parameters for lbfgs --- src/SPIN/min_spin_oso_lbfgs.cpp | 29 +++++++++++++++++++++++++---- 1 file changed, 25 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index e8ac915d8b..a598601532 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -190,10 +190,13 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (iter == 0) energy_force(0); - // dts = evaluate_dt(); - // dts = 1.0; - calc_gradient(1.0); + if (iter == 0){ + energy_force(0); + dts = evaluate_dt(); + } + else dts = 1.0; + + calc_gradient(dts); calc_search_direction(iter); advance_spins(); @@ -371,6 +374,11 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) dyds += ds[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + dyds = dyds_global; + MPI_Allreduce(&dyds_global,&dyds,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; @@ -393,6 +401,10 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) sq += ds[c_ind][i] * q[i]; } MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + sq = sq_global; + MPI_Allreduce(&sq_global,&sq,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } // update alpha @@ -411,6 +423,10 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) yy += dy[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + yy = yy_global; + MPI_Allreduce(&yy_global,&yy,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } // calculate now search direction @@ -435,7 +451,12 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) for (int i = 0; i < 3 * nlocal; i++) { yr += dy[c_ind][i] * p_s[i]; } + MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + yr = yr_global; + MPI_Allreduce(&yr_global,&yr,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } beta = rho[c_ind] * yr_global; for (int i = 0; i < 3 * nlocal; i++) { From 48cc0293ffe7129370163ac8c0aa4c3e5c953e3d Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 12:01:21 +0000 Subject: [PATCH 027/557] if g2 zero then beta is also zero --- src/SPIN/min_spin_oso_cg.cpp | 15 +++++++++++---- 1 file changed, 11 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 8d03ada45d..52bf48d228 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -326,9 +326,8 @@ void MinSpinOSO_CG::calc_search_direction(int iter) double g2 = 0.0; double beta = 0.0; - double g2_global= 0.0; - double g2old_global= 0.0; - + double g2_global = 0.0; + double g2old_global = 0.0; if (iter == 0 || iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i]; @@ -347,8 +346,16 @@ void MinSpinOSO_CG::calc_search_direction(int iter) MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); - beta = g2_global / g2old_global; + // we don't know yet if we need this. Needs to be tested with multiple replica. + // if (update->multireplica == 1) { + // g2 = g2_global; + // g2old = g2old_global; + // MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + // MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + // } + if (fabs(g2_global) < 1.0e-40) beta = 0.0; + else beta = g2_global / g2old_global; // calculate conjugate direction for (int i = 0; i < 3 * nlocal; i++) { From 87fd17a4d2ce411cfbcff15d1cdd2bc41550570d Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 14:54:02 +0000 Subject: [PATCH 028/557] global dot products --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 37 +++++++++++++++++++++++------- 1 file changed, 29 insertions(+), 8 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index 38a557266e..2e124466ac 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -216,6 +216,9 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) } MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); der_e_cur = der_e_cur_global; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_global,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } } if (use_line_search){ @@ -388,7 +391,7 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) // for some reason on a second iteration g_old = 0 // so we make two iterations as steepest descent - + if (iter == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i]; @@ -405,7 +408,12 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) dyds += ds[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); - if (fabs(dyds) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; + if (update->multireplica == 1) { + dyds = dyds_global; + MPI_Allreduce(&dyds_global,&dyds,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; // set the q vector @@ -427,7 +435,10 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) sq += ds[c_ind][i] * q[i]; } MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); - + if (update->multireplica == 1) { + sq = sq_global; + MPI_Allreduce(&sq_global,&sq,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } // update alpha alpha[c_ind] = rho[c_ind] * sq_global; @@ -445,8 +456,12 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) yy += dy[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + yy = yy_global; + MPI_Allreduce(&yy_global,&yy,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } - // calculate now search direction + // calculate now search direction if (fabs(yy_global) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { @@ -470,6 +485,10 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) yr += dy[c_ind][i] * p_s[i]; } MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + yr = yr_global; + MPI_Allreduce(&yr_global,&yr,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } beta = rho[c_ind] * yr_global; for (int i = 0; i < 3 * nlocal; i++) { @@ -661,6 +680,9 @@ void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) } MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); der_e_cur = der_e_cur_global; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_global,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } energy_and_der[0] = ecurrent; energy_and_der[1] = der_e_cur; @@ -685,10 +707,9 @@ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 3){ MPI_Bcast(&b,1,MPI_DOUBLE,0,world); - - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = b * p_s[i]; - } + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } return 1; } else{ From 747245ee907151deb6cd691f9d53b43972f033d3 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 15:06:53 +0000 Subject: [PATCH 029/557] sum beta over all replicas in cg. Good for GNEB --- src/SPIN/min_spin_oso_cg.cpp | 14 +++++++------- 1 file changed, 7 insertions(+), 7 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 52bf48d228..1b4e33ace3 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -346,13 +346,13 @@ void MinSpinOSO_CG::calc_search_direction(int iter) MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); - // we don't know yet if we need this. Needs to be tested with multiple replica. - // if (update->multireplica == 1) { - // g2 = g2_global; - // g2old = g2old_global; - // MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - // MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - // } + // Sum over all replicas. Good for GNEB. + if (update->multireplica == 1) { + g2 = g2_global; + g2old = g2old_global; + MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } if (fabs(g2_global) < 1.0e-40) beta = 0.0; else beta = g2_global / g2old_global; From eb9f5cf1286ece343803217c573a72961d5d1cc3 Mon Sep 17 00:00:00 2001 From: Jared Date: Thu, 27 Jun 2019 17:50:45 +0200 Subject: [PATCH 030/557] Update gcmc to have a max and min --- src/MC/fix_gcmc.cpp | 26 ++++++++++++++++++++++---- src/MC/fix_gcmc.h | 2 ++ 2 files changed, 24 insertions(+), 4 deletions(-) diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 7ab0879335..51f781e4d9 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -272,6 +272,8 @@ void FixGCMC::options(int narg, char **arg) tfac_insert = 1.0; overlap_cutoffsq = 0.0; overlap_flag = 0; + min_ngas = -1; + max_ngas = -1; int iarg = 0; while (iarg < narg) { @@ -391,6 +393,14 @@ void FixGCMC::options(int narg, char **arg) overlap_cutoffsq = rtmp*rtmp; overlap_flag = 1; iarg += 2; + } else if (strcmp(arg[iarg],"min") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix gcmc command"); + min_ngas = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"max") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix gcmc command"); + max_ngas = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; } else error->all(FLERR,"Illegal fix gcmc command"); } } @@ -897,7 +907,7 @@ void FixGCMC::attempt_atomic_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; int i = pick_random_gas_atom(); @@ -938,6 +948,8 @@ void FixGCMC::attempt_atomic_insertion() ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + // pick coordinates for insertion point double coord[3]; @@ -1252,7 +1264,7 @@ void FixGCMC::attempt_molecule_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -1291,6 +1303,8 @@ void FixGCMC::attempt_molecule_insertion() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double com_coord[3]; if (regionflag) { int region_attempt = 0; @@ -1574,7 +1588,7 @@ void FixGCMC::attempt_atomic_deletion_full() ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; double energy_before = energy_stored; @@ -1623,6 +1637,8 @@ void FixGCMC::attempt_atomic_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double energy_before = energy_stored; double coord[3]; @@ -1918,7 +1934,7 @@ void FixGCMC::attempt_molecule_deletion_full() { ndeletion_attempts += 1.0; - if (ngas == 0) return; + if (ngas == 0 || ngas == min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -2001,6 +2017,8 @@ void FixGCMC::attempt_molecule_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; + if (ngas == max_ngas) return; + double energy_before = energy_stored; tagint maxmol = 0; diff --git a/src/MC/fix_gcmc.h b/src/MC/fix_gcmc.h index 5d0b7aab8f..e19a42ef73 100644 --- a/src/MC/fix_gcmc.h +++ b/src/MC/fix_gcmc.h @@ -120,6 +120,8 @@ class FixGCMC : public Fix { imageint imagezero; double overlap_cutoffsq; // square distance cutoff for overlap int overlap_flag; + int max_ngas; + int min_ngas; double energy_intra; From fb63c5a7085f3f5d6362f4cf3515bcd9666e469d Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 3 Jul 2019 09:37:43 -0600 Subject: [PATCH 031/557] Commit1 JT 070319 - commit before pull --- src/SPIN/min_spin_oso_cg.cpp | 8 ++++---- src/SPIN/neb_spin.cpp | 2 ++ 2 files changed, 6 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 52bf48d228..094ae376aa 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -154,8 +154,6 @@ void MinSpinOSO_CG::reset_vectors() minimization via damped spin dynamics ------------------------------------------------------------------------- */ -// g_old g_cur p_s - int MinSpinOSO_CG::iterate(int maxiter) { int nlocal = atom->nlocal; @@ -163,6 +161,8 @@ int MinSpinOSO_CG::iterate(int maxiter) double fmdotfm; int flag, flagall; + // grow tables if nlocal increased + if (nlocal_max < nlocal) { nlocal_max = nlocal; memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); @@ -354,8 +354,8 @@ void MinSpinOSO_CG::calc_search_direction(int iter) // MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); // } - if (fabs(g2_global) < 1.0e-40) beta = 0.0; - else beta = g2_global / g2old_global; + //if (fabs(g2_global) < 1.0e-40) beta = 0.0; + //else beta = g2_global / g2old_global; // calculate conjugate direction for (int i = 0; i < 3 * nlocal; i++) { diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 9ab461cbe6..12d1d2a956 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -252,6 +252,8 @@ void NEBSpin::run() timer->init(); timer->barrier_start(); + // if(ireplica != 0 && ireplica != nreplica -1) + while (update->minimize->niter < n1steps) { update->minimize->run(nevery); print_status(); From 526e0da0a90bdd55458892a959b1bf1c60ce6204 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 15:41:29 +0000 Subject: [PATCH 032/557] reduce correctly over the universe --- src/SPIN/min_spin_oso_lbfgs.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index a598601532..5604f99752 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -376,7 +376,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { dyds = dyds_global; - MPI_Allreduce(&dyds_global,&dyds,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&dyds, &dyds_global, 1,MPI_DOUBLE,MPI_SUM,universe->uworld); } if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; @@ -403,7 +403,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { sq = sq_global; - MPI_Allreduce(&sq_global,&sq,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } // update alpha @@ -425,7 +425,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { yy = yy_global; - MPI_Allreduce(&yy_global,&yy,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } // calculate now search direction @@ -455,7 +455,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { yr = yr_global; - MPI_Allreduce(&yr_global,&yr,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } beta = rho[c_ind] * yr_global; From 99e58d889cdf3ba9794cd97b5315b891120b165b Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 3 Jul 2019 10:48:11 -0600 Subject: [PATCH 033/557] Commit2 JT 070319 - fixing first and last images in oso_lbfgs.cpp --- src/SPIN/min_spin_oso_lbfgs.cpp | 20 +++++++++++++++++++- src/SPIN/min_spin_oso_lbfgs.h | 5 +++++ 2 files changed, 24 insertions(+), 1 deletion(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 5604f99752..a14bf7c4fd 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -39,6 +39,8 @@ #include "math_special.h" #include "math_const.h" +#include "universe.h" + using namespace LAMMPS_NS; using namespace MathConst; @@ -66,6 +68,13 @@ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); nlocal_max = 0; + + // nreplica = number of partitions + // ireplica = which world I am in universe + + nreplica = universe->nworlds; + ireplica = universe->iworld; + } /* ---------------------------------------------------------------------- */ @@ -198,7 +207,16 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) calc_gradient(dts); calc_search_direction(iter); - advance_spins(); + + // to be checked + // if gneb calc., nreplica > 0 + // then advance spins only if intermediate replica + // otherwise (simple minimization), advance spins + + if (nreplica > 0) { + if(ireplica != 0 && ireplica != nreplica-1) + advance_spins(); + } else advance_spins(); eprevious = ecurrent; ecurrent = energy_force(0); diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 3aa326142c..3fc1d625dd 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -41,6 +41,11 @@ public: void calc_search_direction(int); private: + + + // test + int ireplica,nreplica; + // global and spin timesteps int nlocal_max; // max value of nlocal (for size of lists) From 3c3c7899b4fdceb378c206870ee4e93ff76711df Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 19:33:24 +0000 Subject: [PATCH 034/557] use local iteration counter, needed for neb --- src/SPIN/min_spin_oso_cg.cpp | 13 ++++++++----- src/SPIN/min_spin_oso_cg.h | 3 ++- 2 files changed, 10 insertions(+), 6 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 1b4e33ace3..8f2ba0623b 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -83,7 +83,7 @@ void MinSpinOSO_CG::init() { alpha_damp = 1.0; discrete_factor = 10.0; - + local_iter = 0; Min::init(); dts = dt = update->dt; @@ -164,6 +164,7 @@ int MinSpinOSO_CG::iterate(int maxiter) int flag, flagall; if (nlocal_max < nlocal) { + local_iter = 0; nlocal_max = nlocal; memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); @@ -181,11 +182,11 @@ int MinSpinOSO_CG::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (iter == 0) energy_force(0); + if (local_iter == 0) energy_force(0); dts = evaluate_dt(); calc_gradient(dts); - calc_search_direction(iter); + calc_search_direction(); advance_spins(); eprevious = ecurrent; @@ -319,7 +320,7 @@ void MinSpinOSO_CG::calc_gradient(double dts) Optimization' Second Edition, 2006 (p. 121) ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::calc_search_direction(int iter) +void MinSpinOSO_CG::calc_search_direction() { int nlocal = atom->nlocal; double g2old = 0.0; @@ -328,7 +329,7 @@ void MinSpinOSO_CG::calc_search_direction(int iter) double g2_global = 0.0; double g2old_global = 0.0; - if (iter == 0 || iter % 5 == 0){ // steepest descent direction + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i]; g_old[i] = g_cur[i]; @@ -363,6 +364,8 @@ void MinSpinOSO_CG::calc_search_direction(int iter) g_old[i] = g_cur[i]; } } + + local_iter++; } /* ---------------------------------------------------------------------- diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index a791754836..3a3d24f078 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -38,7 +38,7 @@ public: void advance_spins(); double fmnorm_sqr(); void calc_gradient(double); - void calc_search_direction(int); + void calc_search_direction(); private: // global and spin timesteps @@ -56,6 +56,7 @@ private: double *g_old; // gradient vector at previous iteration double *g_cur; // current gradient vector double *p_s; // search direction vector + int local_iter; // number of times we call search_direction void vm3(const double *, const double *, double *); void rodrigues_rotation(const double *, double *); From 95cf85f1b932acc983ab826c90cdcc78e3991751 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 3 Jul 2019 21:12:04 +0000 Subject: [PATCH 035/557] bug: forget to calculate beta.. --- src/SPIN/min_spin_oso_cg.cpp | 5 ++--- 1 file changed, 2 insertions(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 6ae2518986..d8535b19c4 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -355,10 +355,9 @@ void MinSpinOSO_CG::calc_search_direction() MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - //if (fabs(g2_global) < 1.0e-40) beta = 0.0; - //else beta = g2_global / g2old_global; + if (fabs(g2_global) < 1.0e-60) beta = 0.0; + else beta = g2_global / g2old_global; // calculate conjugate direction - for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = beta * p_s[i] - g_cur[i]; g_old[i] = g_cur[i]; From e85bdd17d3a2980f1987f2770c1958c8bbcd8015 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 4 Jul 2019 15:31:18 +0000 Subject: [PATCH 036/557] introduce cutoff step. make lbfgs stable --- src/SPIN/min_spin_oso_lbfgs.cpp | 107 +++++++++++++++++++++++++------- src/SPIN/min_spin_oso_lbfgs.h | 12 ++-- 2 files changed, 92 insertions(+), 27 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index a14bf7c4fd..09948ac3e5 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -38,7 +38,6 @@ #include "modify.h" #include "math_special.h" #include "math_const.h" - #include "universe.h" using namespace LAMMPS_NS; @@ -96,6 +95,8 @@ void MinSpinOSO_LBFGS::init() alpha_damp = 1.0; discrete_factor = 10.0; num_mem = 3; + local_iter = 0; + maxepsrot = MY_2PI / (200.0); Min::init(); @@ -180,6 +181,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) if (nlocal_max < nlocal) { nlocal_max = nlocal; + local_iter = 0; memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs:g_old"); memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs:g_cur"); memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs:p_s"); @@ -198,26 +200,26 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - - if (iter == 0){ - energy_force(0); - dts = evaluate_dt(); - } - else dts = 1.0; + if (local_iter == 0) energy_force(0); + // to be checked + // if gneb calc., nreplica > 1 + // then calculate gradients of intermediate replicas - calc_gradient(dts); + if (nreplica > 1) { + if(ireplica != 0 && ireplica != nreplica-1) + calc_gradient(1.0); + } else calc_gradient(1.0); calc_search_direction(iter); // to be checked - // if gneb calc., nreplica > 0 + // if gneb calc., nreplica > 1 // then advance spins only if intermediate replica // otherwise (simple minimization), advance spins - if (nreplica > 0) { + if (nreplica > 1) { if(ireplica != 0 && ireplica != nreplica-1) advance_spins(); } else advance_spins(); - eprevious = ecurrent; ecurrent = energy_force(0); neval++; @@ -307,7 +309,7 @@ double MinSpinOSO_LBFGS::evaluate_dt() // define max timestep by dividing by the // inverse of max frequency by discrete_factor - + // std::cout << fmaxsqall << "\n"; dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); return dtmax; @@ -365,20 +367,31 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) double yr_global = 0.0; double beta_global = 0.0; - int m_index = iter % num_mem; // memory index + int m_index = local_iter % num_mem; // memory index int c_ind = 0; double *q; double *alpha; + double factor; + double scaling; + + if (nreplica > 1) { + if (ireplica == 0 || ireplica == nreplica - 1) { + factor = 0.0; + } + else factor = 1.0; + }else{ + factor = 1.0; + } + q = (double *) calloc(3*nlocal, sizeof(double)); alpha = (double *) calloc(num_mem, sizeof(double)); - // for some reason on a second iteration g_old = 0 - // so we make two iterations as steepest descent - - if (iter == 0){ // steepest descent direction + if (local_iter == 0){ // steepest descent direction + + scaling = maximum_rotation(g_cur); for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i]; + p_s[i] = - g_cur[i] * factor * scaling; g_old[i] = g_cur[i]; ds[m_index][i] = 0.0; dy[m_index][i] = 0.0; @@ -392,7 +405,9 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) dyds += ds[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + dyds_global *= factor; dyds = dyds_global; MPI_Allreduce(&dyds, &dyds_global, 1,MPI_DOUBLE,MPI_SUM,universe->uworld); } @@ -400,6 +415,17 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; + if (rho[m_index] < 0.0){ + local_iter = 0; + for (int k = 0; k < num_mem; k++){ + for (int i = 0; i < nlocal; i ++){ + ds[k][i] = 0.0; + dy[k][i] = 0.0; + } + } + return calc_search_direction(0); + } + // set the q vector for (int i = 0; i < 3 * nlocal; i++) { @@ -420,6 +446,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) } MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + sq_global *= factor; sq = sq_global; MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } @@ -442,19 +469,22 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) } MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + yy_global *= factor; yy = yy_global; MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } // calculate now search direction - if (fabs(yy_global) > 1.0e-60) { + double devis = rho[m_index] * yy_global; + + if (fabs(devis) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = q[i] / (rho[m_index] * yy_global); + p_s[i] = factor * q[i] / devis; } }else{ for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = q[i] * 1.0e60; + p_s[i] = factor * q[i] * 1.0e60; } } @@ -472,6 +502,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + yr_global *= factor; yr = yr_global; MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } @@ -481,12 +512,14 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); } } + scaling = maximum_rotation(p_s); for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -1.0 * p_s[i]; + p_s[i] = - factor * p_s[i] * scaling; g_old[i] = g_cur[i]; } } + local_iter++; free(q); free(alpha); @@ -631,3 +664,33 @@ void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) } } } + +double MinSpinOSO_LBFGS::maximum_rotation(double *p) +{ + double norm, norm_global, scaling, alpha; + int nlocal = atom->nlocal; + int ntotal = 0; + + norm = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm += p[i] * p[i]; + + MPI_Allreduce(&norm,&norm_global,1,MPI_DOUBLE,MPI_SUM,world); + if (update->multireplica == 1) { + norm = norm_global; + MPI_Allreduce(&norm,&norm_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); + if (update->multireplica == 1) { + nlocal = ntotal; + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); + } + + scaling = (maxepsrot * sqrt((double) ntotal / norm_global)); + + if (scaling < 1.0) alpha = scaling; + else alpha = 1.0; + + return alpha; +} + diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 3fc1d625dd..dfc4ec06ff 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -38,8 +38,8 @@ public: void advance_spins(); double fmnorm_sqr(); void calc_gradient(double); - void calc_search_direction(int); - + void calc_search_direction(int); + double maximum_rotation(double *); private: @@ -64,11 +64,13 @@ private: double **ds; // change in rotation matrix between two iterations, da double **dy; // change in gradients between two iterations, dg double *rho; // estimation of curvature - int num_mem; // number of stored steps + int num_mem; // number of stored steps + int local_iter; // number of times we call search_direction + double maxepsrot; - void vm3(const double *m, const double *v, double *out); - void rodrigues_rotation(const double *upp_tr, double *out); + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); bigint last_negative; }; From f3985c853edace460556d87ff22ed81de884cb25 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 4 Jul 2019 18:19:57 +0000 Subject: [PATCH 037/557] local iter instead of iter --- src/SPIN/min_spin_oso_lbfgs.cpp | 12 ++++++------ src/SPIN/min_spin_oso_lbfgs.h | 2 +- 2 files changed, 7 insertions(+), 7 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 09948ac3e5..9687f2f64d 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -96,7 +96,7 @@ void MinSpinOSO_LBFGS::init() discrete_factor = 10.0; num_mem = 3; local_iter = 0; - maxepsrot = MY_2PI / (200.0); + maxepsrot = MY_2PI / (100.0); Min::init(); @@ -209,7 +209,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) if(ireplica != 0 && ireplica != nreplica-1) calc_gradient(1.0); } else calc_gradient(1.0); - calc_search_direction(iter); + calc_search_direction(); // to be checked // if gneb calc., nreplica > 1 @@ -351,7 +351,7 @@ void MinSpinOSO_LBFGS::calc_gradient(double dts) Optimization' Second Edition, 2006 (p. 177) ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::calc_search_direction(int iter) +void MinSpinOSO_LBFGS::calc_search_direction() { int nlocal = atom->nlocal; @@ -418,12 +418,12 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) if (rho[m_index] < 0.0){ local_iter = 0; for (int k = 0; k < num_mem; k++){ - for (int i = 0; i < nlocal; i ++){ + for (int i = 0; i < nlocal; i ++){ ds[k][i] = 0.0; dy[k][i] = 0.0; } } - return calc_search_direction(0); + return calc_search_direction(); } // set the q vector @@ -491,7 +491,7 @@ void MinSpinOSO_LBFGS::calc_search_direction(int iter) for (int k = 0; k < num_mem; k++){ // this loop should run from the oldest memory to the newest one. - if (iter < num_mem) c_ind = k; + if (local_iter < num_mem) c_ind = k; else c_ind = (k + m_index + 1) % num_mem; // dot product between p and da diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index dfc4ec06ff..c0f8dc484d 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -38,7 +38,7 @@ public: void advance_spins(); double fmnorm_sqr(); void calc_gradient(double); - void calc_search_direction(int); + void calc_search_direction(); double maximum_rotation(double *); private: From 79f8e422f9f8ee044db5b9e5cb7cee6b637e3dff Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 4 Jul 2019 18:21:07 +0000 Subject: [PATCH 038/557] indentation --- src/SPIN/min_spin_oso_lbfgs.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 9687f2f64d..fd83e7b460 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -418,7 +418,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() if (rho[m_index] < 0.0){ local_iter = 0; for (int k = 0; k < num_mem; k++){ - for (int i = 0; i < nlocal; i ++){ + for (int i = 0; i < nlocal; i ++){ ds[k][i] = 0.0; dy[k][i] = 0.0; } From bb325a335ed3c8a8e612142aff2547461a3c35d3 Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 10 Jul 2019 09:52:39 -0600 Subject: [PATCH 039/557] Commit1 JT 070919 - test energy/torque modif with etotal --- src/SPIN/pair_spin_dmi.cpp | 8 ++++---- src/SPIN/pair_spin_exchange.cpp | 8 ++++---- 2 files changed, 8 insertions(+), 8 deletions(-) diff --git a/src/SPIN/pair_spin_dmi.cpp b/src/SPIN/pair_spin_dmi.cpp index 41430d230f..817d933698 100644 --- a/src/SPIN/pair_spin_dmi.cpp +++ b/src/SPIN/pair_spin_dmi.cpp @@ -317,7 +317,7 @@ void PairSpinDmi::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, @@ -431,9 +431,9 @@ void PairSpinDmi::compute_dmi(int i, int j, double eij[3], double fmi[3], double dmiy = eij[2]*v_dmx[itype][jtype] - eij[0]*v_dmz[itype][jtype]; dmiz = eij[0]*v_dmy[itype][jtype] - eij[1]*v_dmx[itype][jtype]; - fmi[0] -= (dmiy*spj[2] - dmiz*spj[1]); - fmi[1] -= (dmiz*spj[0] - dmix*spj[2]); - fmi[2] -= (dmix*spj[1] - dmiy*spj[0]); + fmi[0] -= 2.0*(dmiy*spj[2] - dmiz*spj[1]); + fmi[1] -= 2.0*(dmiz*spj[0] - dmix*spj[2]); + fmi[2] -= 2.0*(dmix*spj[1] - dmiy*spj[0]); } /* ---------------------------------------------------------------------- diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index 93b6d9501e..721002acba 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -300,7 +300,7 @@ void PairSpinExchange::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, @@ -409,9 +409,9 @@ void PairSpinExchange::compute_exchange(int i, int j, double rsq, double fmi[3], Jex *= (1.0-J2[itype][jtype]*ra); Jex *= exp(-ra); - fmi[0] += Jex*spj[0]; - fmi[1] += Jex*spj[1]; - fmi[2] += Jex*spj[2]; + fmi[0] += 2.0*Jex*spj[0]; + fmi[1] += 2.0*Jex*spj[1]; + fmi[2] += 2.0*Jex*spj[2]; } /* ---------------------------------------------------------------------- From 2b2a9e775eed2d8991d776e3f50afd9f678f130c Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 11 Jul 2019 08:24:28 +0000 Subject: [PATCH 040/557] fix memory, add sp_copy --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index 2e124466ac..0d9c2d7c51 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -64,7 +64,7 @@ static const char cite_minstyle_spin_oso_lbfgs_ls[] = /* ---------------------------------------------------------------------- */ MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL) + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL), sp_copy(NULL) { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs_ls); nlocal_max = 0; From 6238ad321228ef4320dc0f006b30f6e150ed7890 Mon Sep 17 00:00:00 2001 From: alxvov Date: Thu, 11 Jul 2019 14:18:42 +0000 Subject: [PATCH 041/557] local iterator, broadcast more --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 100 ++++++++++++++++++++--------- src/SPIN/min_spin_oso_lbfgs_ls.h | 6 +- 2 files changed, 75 insertions(+), 31 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index 0d9c2d7c51..e1a6ae99d5 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -38,6 +38,7 @@ #include "modify.h" #include "math_special.h" #include "math_const.h" +#include "universe.h" #include @@ -68,6 +69,13 @@ MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs_ls); nlocal_max = 0; + + // nreplica = number of partitions + // ireplica = which world I am in universe + + nreplica = universe->nworlds; + ireplica = universe->iworld; + } /* ---------------------------------------------------------------------- */ @@ -90,6 +98,7 @@ void MinSpinOSO_LBFGS_LS::init() alpha_damp = 1.0; discrete_factor = 10.0; num_mem = 3; + local_iter = 0; der_e_cur = 0.0; der_e_pr = 0.0; use_line_search = 1; @@ -189,7 +198,6 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); } - for (int iter = 0; iter < maxiter; iter++) { if (timer->check_timeout(niter)) @@ -201,13 +209,12 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (iter == 0){ + if (local_iter == 0){ ecurrent = energy_force(0); calc_gradient(1.0); neval++; - }else{ } - calc_search_direction(iter); + calc_search_direction(); if (use_line_search) { der_e_cur = 0.0; @@ -365,7 +372,7 @@ void MinSpinOSO_LBFGS_LS::calc_gradient(double dts) Optimization' Second Edition, 2006 (p. 177) ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) +void MinSpinOSO_LBFGS_LS::calc_search_direction() { int nlocal = atom->nlocal; @@ -381,41 +388,64 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) double yr_global = 0.0; double beta_global = 0.0; - int m_index = iter % num_mem; // memory index + int m_index = local_iter % num_mem; // memory index int c_ind = 0; double *q; double *alpha; + double factor; + + if (nreplica > 1) { + if (ireplica == 0 || ireplica == nreplica - 1) { + factor = 0.0; + } + else factor = 1.0; + }else{ + factor = 1.0; + } + q = (double *) calloc(3*nlocal, sizeof(double)); alpha = (double *) calloc(num_mem, sizeof(double)); - // for some reason on a second iteration g_old = 0 - // so we make two iterations as steepest descent - - if (iter == 0){ // steepest descent direction + if (local_iter == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i]; g_old[i] = g_cur[i]; - ds[m_index][i] = 0.0; - dy[m_index][i] = 0.0; - + for (int k = 0; k < num_mem; k++){ + ds[k][i] = 0.0; + dy[k][i] = 0.0; + rho[k] = 0.0; + } } } else { - dyds = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - ds[m_index][i] = p_s[i]; - dy[m_index][i] = g_cur[i] - g_old[i]; - dyds += ds[m_index][i] * dy[m_index][i]; - } + dyds = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + ds[m_index][i] = p_s[i]; + dy[m_index][i] = g_cur[i] - g_old[i]; + dyds += ds[m_index][i] * dy[m_index][i]; + } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); + if (update->multireplica == 1) { + dyds_global *= factor; dyds = dyds_global; - MPI_Allreduce(&dyds_global,&dyds,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&dyds, &dyds_global, 1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; + if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; else rho[m_index] = 1.0e60; + if (rho[m_index] < 0.0){ + local_iter = 0; + for (int k = 0; k < num_mem; k++){ + for (int i = 0; i < nlocal; i ++){ + ds[k][i] = 0.0; + dy[k][i] = 0.0; + } + } + return calc_search_direction(); + } + // set the q vector for (int i = 0; i < 3 * nlocal; i++) { @@ -436,9 +466,11 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) } MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + sq_global *= factor; sq = sq_global; - MPI_Allreduce(&sq_global,&sq,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } + // update alpha alpha[c_ind] = rho[c_ind] * sq_global; @@ -457,26 +489,29 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) } MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + yy_global *= factor; yy = yy_global; - MPI_Allreduce(&yy_global,&yy,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } // calculate now search direction - if (fabs(yy_global) > 1.0e-60) { + double devis = rho[m_index] * yy_global; + + if (fabs(devis) > 1.0e-60) { for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = q[i] / (rho[m_index] * yy_global); + p_s[i] = factor * q[i] / devis; } }else{ for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = q[i] * 1.0e60; + p_s[i] = factor * q[i] * 1.0e60; } } for (int k = 0; k < num_mem; k++){ // this loop should run from the oldest memory to the newest one. - if (iter < num_mem) c_ind = k; + if (local_iter < num_mem) c_ind = k; else c_ind = (k + m_index + 1) % num_mem; // dot product between p and da @@ -484,10 +519,12 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) for (int i = 0; i < 3 * nlocal; i++) { yr += dy[c_ind][i] * p_s[i]; } + MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); if (update->multireplica == 1) { + yr_global *= factor; yr = yr_global; - MPI_Allreduce(&yr_global,&yr,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } beta = rho[c_ind] * yr_global; @@ -496,11 +533,12 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction(int iter) } } for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -1.0 * p_s[i]; + p_s[i] = - factor * p_s[i]; g_old[i] = g_cur[i]; } } + local_iter++; free(q); free(alpha); @@ -705,7 +743,7 @@ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) der_e_cur = e_and_d[1]; index++; - if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 3){ + if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 5){ MPI_Bcast(&b,1,MPI_DOUBLE,0,world); for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = b * p_s[i]; @@ -728,6 +766,8 @@ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) // has minimum at alpha below. We do not check boundaries. alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); + if (alpha < 0.0) alpha = r/2.0; for (int i = 0; i < nlocal; i++) { diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.h b/src/SPIN/min_spin_oso_lbfgs_ls.h index 3e0e608ecb..eeaf20adf4 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.h +++ b/src/SPIN/min_spin_oso_lbfgs_ls.h @@ -38,9 +38,12 @@ public: void advance_spins(); double fmnorm_sqr(); void calc_gradient(double); - void calc_search_direction(int); + void calc_search_direction(); private: + // test + int ireplica,nreplica; + // global and spin timesteps int nlocal_max; // max value of nlocal (for size of lists) @@ -62,6 +65,7 @@ private: double **sp_copy; // copy of the spins int num_mem; // number of stored steps + int local_iter; double der_e_cur; // current derivative along search dir. double der_e_pr; // previous derivative along search dir. From 095b4f11d8960893c1cf59858edc73812c2d059a Mon Sep 17 00:00:00 2001 From: Jun-Chieh Wang Date: Wed, 17 Jul 2019 19:04:06 -0700 Subject: [PATCH 042/557] throw away random numbers --- src/fix_deposit.cpp | 880 ++++++++++++++++++++++++++++++++++++++++++++ 1 file changed, 880 insertions(+) create mode 100644 src/fix_deposit.cpp diff --git a/src/fix_deposit.cpp b/src/fix_deposit.cpp new file mode 100644 index 0000000000..ca841b49bd --- /dev/null +++ b/src/fix_deposit.cpp @@ -0,0 +1,880 @@ +/* ---------------------------------------------------------------------- + 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 "fix_deposit.h" +#include "atom.h" +#include "atom_vec.h" +#include "molecule.h" +#include "force.h" +#include "update.h" +#include "modify.h" +#include "fix.h" +#include "comm.h" +#include "domain.h" +#include "lattice.h" +#include "region.h" +#include "random_park.h" +#include "math_extra.h" +#include "math_const.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; +using namespace FixConst; +using namespace MathConst; + +enum{ATOM,MOLECULE}; +enum{DIST_UNIFORM,DIST_GAUSSIAN}; + +#define EPSILON 1.0e6 + +/* ---------------------------------------------------------------------- */ + +FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : + Fix(lmp, narg, arg), idregion(NULL), idrigid(NULL), + idshake(NULL), onemols(NULL), molfrac(NULL), coords(NULL), imageflags(NULL), + fixrigid(NULL), fixshake(NULL), random(NULL) +{ + if (narg < 7) error->all(FLERR,"Illegal fix deposit command"); + + restart_global = 1; + time_depend = 1; + + // required args + + ninsert = force->inumeric(FLERR,arg[3]); + ntype = force->inumeric(FLERR,arg[4]); + nfreq = force->inumeric(FLERR,arg[5]); + seed = force->inumeric(FLERR,arg[6]); + + if (seed <= 0) error->all(FLERR,"Illegal fix deposit command"); + + // read options from end of input line + + options(narg-7,&arg[7]); + + // error check on type + + if (mode == ATOM && (ntype <= 0 || ntype > atom->ntypes)) + error->all(FLERR,"Invalid atom type in fix deposit command"); + + // error checks on region and its extent being inside simulation box + + if (iregion == -1) error->all(FLERR,"Must specify a region in fix deposit"); + if (domain->regions[iregion]->bboxflag == 0) + error->all(FLERR,"Fix deposit region does not support a bounding box"); + if (domain->regions[iregion]->dynamic_check()) + error->all(FLERR,"Fix deposit region cannot be dynamic"); + + xlo = domain->regions[iregion]->extent_xlo; + xhi = domain->regions[iregion]->extent_xhi; + ylo = domain->regions[iregion]->extent_ylo; + yhi = domain->regions[iregion]->extent_yhi; + zlo = domain->regions[iregion]->extent_zlo; + zhi = domain->regions[iregion]->extent_zhi; + + if (domain->triclinic == 0) { + if (xlo < domain->boxlo[0] || xhi > domain->boxhi[0] || + ylo < domain->boxlo[1] || yhi > domain->boxhi[1] || + zlo < domain->boxlo[2] || zhi > domain->boxhi[2]) + error->all(FLERR,"Deposition region extends outside simulation box"); + } else { + if (xlo < domain->boxlo_bound[0] || xhi > domain->boxhi_bound[0] || + ylo < domain->boxlo_bound[1] || yhi > domain->boxhi_bound[1] || + zlo < domain->boxlo_bound[2] || zhi > domain->boxhi_bound[2]) + error->all(FLERR,"Deposition region extends outside simulation box"); + } + + // error check and further setup for mode = MOLECULE + + if (atom->tag_enable == 0) + error->all(FLERR,"Cannot use fix_deposit unless atoms have IDs"); + + if (mode == MOLECULE) { + for (int i = 0; i < nmol; i++) { + if (onemols[i]->xflag == 0) + error->all(FLERR,"Fix deposit molecule must have coordinates"); + if (onemols[i]->typeflag == 0) + error->all(FLERR,"Fix deposit molecule must have atom types"); + if (ntype+onemols[i]->ntypes <= 0 || + ntype+onemols[i]->ntypes > atom->ntypes) + error->all(FLERR,"Invalid atom type in fix deposit mol command"); + + if (atom->molecular == 2 && onemols != atom->avec->onemols) + error->all(FLERR,"Fix deposit molecule template ID must be same " + "as atom_style template ID"); + onemols[i]->check_attributes(0); + + // fix deposit uses geoemetric center of molecule for insertion + + onemols[i]->compute_center(); + } + } + + if (rigidflag && mode == ATOM) + error->all(FLERR,"Cannot use fix deposit rigid and not molecule"); + if (shakeflag && mode == ATOM) + error->all(FLERR,"Cannot use fix deposit shake and not molecule"); + if (rigidflag && shakeflag) + error->all(FLERR,"Cannot use fix deposit rigid and shake"); + + // setup of coords and imageflags array + + if (mode == ATOM) natom_max = 1; + else { + natom_max = 0; + for (int i = 0; i < nmol; i++) + natom_max = MAX(natom_max,onemols[i]->natoms); + } + memory->create(coords,natom_max,3,"deposit:coords"); + memory->create(imageflags,natom_max,"deposit:imageflags"); + + // setup scaling + + double xscale,yscale,zscale; + if (scaleflag) { + xscale = domain->lattice->xlattice; + yscale = domain->lattice->ylattice; + zscale = domain->lattice->zlattice; + } + else xscale = yscale = zscale = 1.0; + + // apply scaling to all input parameters with dist/vel units + + if (domain->dimension == 2) { + lo *= yscale; + hi *= yscale; + rate *= yscale; + } else { + lo *= zscale; + hi *= zscale; + rate *= zscale; + } + deltasq *= xscale*xscale; + nearsq *= xscale*xscale; + vxlo *= xscale; + vxhi *= xscale; + vylo *= yscale; + vyhi *= yscale; + vzlo *= zscale; + vzhi *= zscale; + xmid *= xscale; + ymid *= yscale; + zmid *= zscale; + sigma *= xscale; // same as in region sphere + tx *= xscale; + ty *= yscale; + tz *= zscale; + + // find current max atom and molecule IDs if necessary + + if (idnext) find_maxid(); + + // random number generator, same for all procs + + random = new RanPark(lmp,seed); + + // set up reneighboring + + force_reneighbor = 1; + next_reneighbor = update->ntimestep + 1; + nfirst = next_reneighbor; + ninserted = 0; +} + +/* ---------------------------------------------------------------------- */ + +FixDeposit::~FixDeposit() +{ + delete random; + delete [] molfrac; + delete [] idrigid; + delete [] idshake; + delete [] idregion; + memory->destroy(coords); + memory->destroy(imageflags); +} + +/* ---------------------------------------------------------------------- */ + +int FixDeposit::setmask() +{ + int mask = 0; + mask |= PRE_EXCHANGE; + return mask; +} + +/* ---------------------------------------------------------------------- */ + +void FixDeposit::init() +{ + // set index and check validity of region + + iregion = domain->find_region(idregion); + if (iregion == -1) + error->all(FLERR,"Region ID for fix deposit does not exist"); + + // if rigidflag defined, check for rigid/small fix + // its molecule template must be same as this one + + fixrigid = NULL; + if (rigidflag) { + int ifix = modify->find_fix(idrigid); + if (ifix < 0) error->all(FLERR,"Fix deposit rigid fix does not exist"); + fixrigid = modify->fix[ifix]; + int tmp; + if (onemols != (Molecule **) fixrigid->extract("onemol",tmp)) + error->all(FLERR, + "Fix deposit and fix rigid/small not using " + "same molecule template ID"); + } + + // if shakeflag defined, check for SHAKE fix + // its molecule template must be same as this one + + fixshake = NULL; + if (shakeflag) { + int ifix = modify->find_fix(idshake); + if (ifix < 0) error->all(FLERR,"Fix deposit shake fix does not exist"); + fixshake = modify->fix[ifix]; + int tmp; + if (onemols != (Molecule **) fixshake->extract("onemol",tmp)) + error->all(FLERR,"Fix deposit and fix shake not using " + "same molecule template ID"); + } + + // for finite size spherical particles: + // warn if near < 2 * maxrad of existing and inserted particles + // since may lead to overlaps + // if inserted molecule does not define diameters, + // use AtomVecSphere::create_atom() default radius = 0.5 + + if (atom->radius_flag) { + double *radius = atom->radius; + int nlocal = atom->nlocal; + + double maxrad = 0.0; + for (int i = 0; i < nlocal; i++) + maxrad = MAX(maxrad,radius[i]); + + double maxradall; + MPI_Allreduce(&maxrad,&maxradall,1,MPI_DOUBLE,MPI_MAX,world); + + double maxradinsert = 0.0; + if (mode == MOLECULE) { + for (int i = 0; i < nmol; i++) { + if (onemols[i]->radiusflag) + maxradinsert = MAX(maxradinsert,onemols[i]->maxradius); + else maxradinsert = MAX(maxradinsert,0.5); + } + } else maxradinsert = 0.5; + + double separation = MAX(2.0*maxradinsert,maxradall+maxradinsert); + if (sqrt(nearsq) < separation && comm->me == 0) { + char str[128]; + sprintf(str,"Fix deposit near setting < possible overlap separation %g", + separation); + error->warning(FLERR,str); + } + } +} + +/* ---------------------------------------------------------------------- + perform particle insertion +------------------------------------------------------------------------- */ + +void FixDeposit::pre_exchange() +{ + int i,m,n,nlocalprev,imol,natom,flag,flagall; + double coord[3],lamda[3],delx,dely,delz,rsq; + double r[3],vnew[3],rotmat[3][3],quat[4]; + double *newcoord; + + // just return if should not be called on this timestep + + if (next_reneighbor != update->ntimestep) return; + + // clear ghost count and any ghost bonus data internal to AtomVec + // same logic as beginning of Comm::exchange() + // do it now b/c inserting atoms will overwrite ghost atoms + + atom->nghost = 0; + atom->avec->clear_bonus(); + + // compute current offset = bottom of insertion volume + + double offset = 0.0; + if (rateflag) offset = (update->ntimestep - nfirst) * update->dt * rate; + + double *sublo,*subhi; + if (domain->triclinic == 0) { + sublo = domain->sublo; + subhi = domain->subhi; + } else { + sublo = domain->sublo_lamda; + subhi = domain->subhi_lamda; + } + + // find current max atom and molecule IDs if necessary + + if (!idnext) find_maxid(); + + // attempt an insertion until successful + + int dimension = domain->dimension; + + int success = 0; + int attempt = 0; + while (attempt < maxattempt) { + attempt++; + + // choose random position for new particle within region + if (distflag == DIST_UNIFORM) { + // throw away the first few numbers to avoid the unexpected correlations + double tmp_rand; + for (int ii=0; ii < 30; ii++) { + tmp_rand = random->uniform(); + } + do { + coord[0] = xlo + random->uniform() * (xhi-xlo); + coord[1] = ylo + random->uniform() * (yhi-ylo); + coord[2] = zlo + random->uniform() * (zhi-zlo); + } while (domain->regions[iregion]->match(coord[0],coord[1],coord[2]) == 0); + } else if (distflag == DIST_GAUSSIAN) { + do { + coord[0] = xmid + random->gaussian() * sigma; + coord[1] = ymid + random->gaussian() * sigma; + coord[2] = zmid + random->gaussian() * sigma; + } while (domain->regions[iregion]->match(coord[0],coord[1],coord[2]) == 0); + } else error->all(FLERR,"Unknown particle distribution in fix deposit"); + + // adjust vertical coord by offset + + if (dimension == 2) coord[1] += offset; + else coord[2] += offset; + + // if global, reset vertical coord to be lo-hi above highest atom + // if local, reset vertical coord to be lo-hi above highest "nearby" atom + // local computation computes lateral distance between 2 particles w/ PBC + // when done, have final coord of atom or center pt of molecule + + if (globalflag || localflag) { + int dim; + double max,maxall,delx,dely,delz,rsq; + + if (dimension == 2) { + dim = 1; + max = domain->boxlo[1]; + } else { + dim = 2; + max = domain->boxlo[2]; + } + + double **x = atom->x; + int nlocal = atom->nlocal; + for (i = 0; i < nlocal; i++) { + if (localflag) { + delx = coord[0] - x[i][0]; + dely = coord[1] - x[i][1]; + delz = 0.0; + domain->minimum_image(delx,dely,delz); + if (dimension == 2) rsq = delx*delx; + else rsq = delx*delx + dely*dely; + if (rsq > deltasq) continue; + } + if (x[i][dim] > max) max = x[i][dim]; + } + + MPI_Allreduce(&max,&maxall,1,MPI_DOUBLE,MPI_MAX,world); + if (dimension == 2) + coord[1] = maxall + lo + random->uniform()*(hi-lo); + else + coord[2] = maxall + lo + random->uniform()*(hi-lo); + } + + // coords = coords of all atoms + // for molecule, perform random rotation around center pt + // apply PBC so final coords are inside box + // also modify image flags due to PBC + + if (mode == ATOM) { + natom = 1; + coords[0][0] = coord[0]; + coords[0][1] = coord[1]; + coords[0][2] = coord[2]; + imageflags[0] = ((imageint) IMGMAX << IMG2BITS) | + ((imageint) IMGMAX << IMGBITS) | IMGMAX; + } else { + double rng = random->uniform(); + imol = 0; + while (rng > molfrac[imol]) imol++; + natom = onemols[imol]->natoms; + if (dimension == 3) { + r[0] = random->uniform() - 0.5; + r[1] = random->uniform() - 0.5; + r[2] = random->uniform() - 0.5; + } else { + r[0] = r[1] = 0.0; + r[2] = 1.0; + } + double theta = random->uniform() * MY_2PI; + MathExtra::norm3(r); + MathExtra::axisangle_to_quat(r,theta,quat); + MathExtra::quat_to_mat(quat,rotmat); + for (i = 0; i < natom; i++) { + MathExtra::matvec(rotmat,onemols[imol]->dx[i],coords[i]); + coords[i][0] += coord[0]; + coords[i][1] += coord[1]; + coords[i][2] += coord[2]; + + imageflags[i] = ((imageint) IMGMAX << IMG2BITS) | + ((imageint) IMGMAX << IMGBITS) | IMGMAX; + domain->remap(coords[i],imageflags[i]); + } + } + + // check distance between any existing atom and any inserted atom + // if less than near, try again + // use minimum_image() to account for PBC + + double **x = atom->x; + int nlocal = atom->nlocal; + + flag = 0; + for (m = 0; m < natom; m++) { + for (i = 0; i < nlocal; i++) { + delx = coords[m][0] - x[i][0]; + dely = coords[m][1] - x[i][1]; + delz = coords[m][2] - x[i][2]; + domain->minimum_image(delx,dely,delz); + rsq = delx*delx + dely*dely + delz*delz; + if (rsq < nearsq) flag = 1; + } + } + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_MAX,world); + if (flagall) continue; + + // proceed with insertion + + nlocalprev = atom->nlocal; + + // choose random velocity for new particle + // used for every atom in molecule + + vnew[0] = vxlo + random->uniform() * (vxhi-vxlo); + vnew[1] = vylo + random->uniform() * (vyhi-vylo); + vnew[2] = vzlo + random->uniform() * (vzhi-vzlo); + + // if target specified, change velocity vector accordingly + + if (targetflag) { + double vel = sqrt(vnew[0]*vnew[0] + vnew[1]*vnew[1] + vnew[2]*vnew[2]); + delx = tx - coord[0]; + dely = ty - coord[1]; + delz = tz - coord[2]; + double rsq = delx*delx + dely*dely + delz*delz; + if (rsq > 0.0) { + double rinv = sqrt(1.0/rsq); + vnew[0] = delx*rinv*vel; + vnew[1] = dely*rinv*vel; + vnew[2] = delz*rinv*vel; + } + } + + // check if new atoms are in my sub-box or above it if I am highest proc + // if so, add atom to my list via create_atom() + // initialize additional info about the atoms + // set group mask to "all" plus fix group + + for (m = 0; m < natom; m++) { + if (domain->triclinic) { + domain->x2lamda(coords[m],lamda); + newcoord = lamda; + } else newcoord = coords[m]; + + flag = 0; + if (newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && + newcoord[1] >= sublo[1] && newcoord[1] < subhi[1] && + newcoord[2] >= sublo[2] && newcoord[2] < subhi[2]) flag = 1; + else if (dimension == 3 && newcoord[2] >= domain->boxhi[2]) { + if (comm->layout != Comm::LAYOUT_TILED) { + if (comm->myloc[2] == comm->procgrid[2]-1 && + newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && + newcoord[1] >= sublo[1] && newcoord[1] < subhi[1]) flag = 1; + } else { + if (comm->mysplit[2][1] == 1.0 && + newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && + newcoord[1] >= sublo[1] && newcoord[1] < subhi[1]) flag = 1; + } + } else if (dimension == 2 && newcoord[1] >= domain->boxhi[1]) { + if (comm->layout != Comm::LAYOUT_TILED) { + if (comm->myloc[1] == comm->procgrid[1]-1 && + newcoord[0] >= sublo[0] && newcoord[0] < subhi[0]) flag = 1; + } else { + if (comm->mysplit[1][1] == 1.0 && + newcoord[0] >= sublo[0] && newcoord[0] < subhi[0]) flag = 1; + } + } + + if (flag) { + if (mode == ATOM) atom->avec->create_atom(ntype,coords[m]); + else atom->avec->create_atom(ntype+onemols[imol]->type[m],coords[m]); + n = atom->nlocal - 1; + atom->tag[n] = maxtag_all + m+1; + if (mode == MOLECULE) { + if (atom->molecule_flag) atom->molecule[n] = maxmol_all+1; + if (atom->molecular == 2) { + atom->molindex[n] = 0; + atom->molatom[n] = m; + } + } + atom->mask[n] = 1 | groupbit; + atom->image[n] = imageflags[m]; + atom->v[n][0] = vnew[0]; + atom->v[n][1] = vnew[1]; + atom->v[n][2] = vnew[2]; + if (mode == MOLECULE) { + onemols[imol]->quat_external = quat; + atom->add_molecule_atom(onemols[imol],m,n,maxtag_all); + } + modify->create_attribute(n); + } + } + + // FixRigidSmall::set_molecule stores rigid body attributes + // coord is new position of geometric center of mol, not COM + // FixShake::set_molecule stores shake info for molecule + + if (rigidflag) + fixrigid->set_molecule(nlocalprev,maxtag_all,imol,coord,vnew,quat); + else if (shakeflag) + fixshake->set_molecule(nlocalprev,maxtag_all,imol,coord,vnew,quat); + + // old code: unsuccessful if no proc performed insertion of an atom + // don't think that check is necessary + // if get this far, should always be succesful + // would be hard to undo partial insertion for a molecule + // better to check how many atoms could be inserted (w/out inserting) + // then sum to insure all are inserted, before doing actual insertion + // MPI_Allreduce(&flag,&success,1,MPI_INT,MPI_MAX,world); + + success = 1; + break; + } + + // warn if not successful b/c too many attempts + + if (!success && comm->me == 0) + error->warning(FLERR,"Particle deposition was unsuccessful",0); + + // reset global natoms,nbonds,etc + // increment maxtag_all and maxmol_all if necessary + // if global map exists, reset it now instead of waiting for comm + // since other pre-exchange fixes may use it + // invoke map_init() b/c atom count has grown + + if (success) { + atom->natoms += natom; + if (atom->natoms < 0) + error->all(FLERR,"Too many total atoms"); + if (mode == MOLECULE) { + atom->nbonds += onemols[imol]->nbonds; + atom->nangles += onemols[imol]->nangles; + atom->ndihedrals += onemols[imol]->ndihedrals; + atom->nimpropers += onemols[imol]->nimpropers; + } + maxtag_all += natom; + if (maxtag_all >= MAXTAGINT) + error->all(FLERR,"New atom IDs exceed maximum allowed ID"); + if (mode == MOLECULE && atom->molecule_flag) maxmol_all++; + if (atom->map_style) { + atom->map_init(); + atom->map_set(); + } + } + + // next timestep to insert + // next_reneighbor = 0 if done + + if (success) ninserted++; + if (ninserted < ninsert) next_reneighbor += nfreq; + else next_reneighbor = 0; +} + +/* ---------------------------------------------------------------------- + maxtag_all = current max atom ID for all atoms + maxmol_all = current max molecule ID for all atoms +------------------------------------------------------------------------- */ + +void FixDeposit::find_maxid() +{ + tagint *tag = atom->tag; + tagint *molecule = atom->molecule; + int nlocal = atom->nlocal; + + tagint max = 0; + for (int i = 0; i < nlocal; i++) max = MAX(max,tag[i]); + MPI_Allreduce(&max,&maxtag_all,1,MPI_LMP_TAGINT,MPI_MAX,world); + + if (mode == MOLECULE && molecule) { + max = 0; + for (int i = 0; i < nlocal; i++) max = MAX(max,molecule[i]); + MPI_Allreduce(&max,&maxmol_all,1,MPI_LMP_TAGINT,MPI_MAX,world); + } +} + +/* ---------------------------------------------------------------------- + parse optional parameters at end of input line +------------------------------------------------------------------------- */ + +void FixDeposit::options(int narg, char **arg) +{ + // defaults + + iregion = -1; + idregion = NULL; + mode = ATOM; + molfrac = NULL; + rigidflag = 0; + idrigid = NULL; + shakeflag = 0; + idshake = NULL; + idnext = 0; + globalflag = localflag = 0; + lo = hi = deltasq = 0.0; + nearsq = 0.0; + maxattempt = 10; + rateflag = 0; + vxlo = vxhi = vylo = vyhi = vzlo = vzhi = 0.0; + distflag = DIST_UNIFORM; + sigma = 1.0; + xmid = ymid = zmid = 0.0; + scaleflag = 1; + targetflag = 0; + + int iarg = 0; + while (iarg < narg) { + if (strcmp(arg[iarg],"region") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + iregion = domain->find_region(arg[iarg+1]); + if (iregion == -1) + error->all(FLERR,"Region ID for fix deposit does not exist"); + int n = strlen(arg[iarg+1]) + 1; + idregion = new char[n]; + strcpy(idregion,arg[iarg+1]); + iarg += 2; + + } else if (strcmp(arg[iarg],"mol") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + int imol = atom->find_molecule(arg[iarg+1]); + if (imol == -1) + error->all(FLERR,"Molecule template ID for fix deposit does not exist"); + mode = MOLECULE; + onemols = &atom->molecules[imol]; + nmol = onemols[0]->nset; + delete [] molfrac; + molfrac = new double[nmol]; + molfrac[0] = 1.0/nmol; + for (int i = 1; i < nmol-1; i++) molfrac[i] = molfrac[i-1] + 1.0/nmol; + molfrac[nmol-1] = 1.0; + iarg += 2; + } else if (strcmp(arg[iarg],"molfrac") == 0) { + if (mode != MOLECULE) error->all(FLERR,"Illegal fix deposit command"); + if (iarg+nmol+1 > narg) error->all(FLERR,"Illegal fix deposit command"); + molfrac[0] = force->numeric(FLERR,arg[iarg+1]); + for (int i = 1; i < nmol; i++) + molfrac[i] = molfrac[i-1] + force->numeric(FLERR,arg[iarg+i+1]); + if (molfrac[nmol-1] < 1.0-EPSILON || molfrac[nmol-1] > 1.0+EPSILON) + error->all(FLERR,"Illegal fix deposit command"); + molfrac[nmol-1] = 1.0; + iarg += nmol+1; + + } else if (strcmp(arg[iarg],"rigid") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + int n = strlen(arg[iarg+1]) + 1; + delete [] idrigid; + idrigid = new char[n]; + strcpy(idrigid,arg[iarg+1]); + rigidflag = 1; + iarg += 2; + } else if (strcmp(arg[iarg],"shake") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + int n = strlen(arg[iarg+1]) + 1; + delete [] idshake; + idshake = new char[n]; + strcpy(idshake,arg[iarg+1]); + shakeflag = 1; + iarg += 2; + + } else if (strcmp(arg[iarg],"id") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + if (strcmp(arg[iarg+1],"max") == 0) idnext = 0; + else if (strcmp(arg[iarg+1],"next") == 0) idnext = 1; + else error->all(FLERR,"Illegal fix deposit command"); + iarg += 2; + } else if (strcmp(arg[iarg],"global") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); + globalflag = 1; + localflag = 0; + lo = force->numeric(FLERR,arg[iarg+1]); + hi = force->numeric(FLERR,arg[iarg+2]); + iarg += 3; + } else if (strcmp(arg[iarg],"local") == 0) { + if (iarg+4 > narg) error->all(FLERR,"Illegal fix deposit command"); + localflag = 1; + globalflag = 0; + lo = force->numeric(FLERR,arg[iarg+1]); + hi = force->numeric(FLERR,arg[iarg+2]); + deltasq = force->numeric(FLERR,arg[iarg+3]) * + force->numeric(FLERR,arg[iarg+3]); + iarg += 4; + + } else if (strcmp(arg[iarg],"near") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + nearsq = force->numeric(FLERR,arg[iarg+1]) * + force->numeric(FLERR,arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"attempt") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + maxattempt = force->inumeric(FLERR,arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"rate") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + rateflag = 1; + rate = force->numeric(FLERR,arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"vx") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); + vxlo = force->numeric(FLERR,arg[iarg+1]); + vxhi = force->numeric(FLERR,arg[iarg+2]); + iarg += 3; + } else if (strcmp(arg[iarg],"vy") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); + vylo = force->numeric(FLERR,arg[iarg+1]); + vyhi = force->numeric(FLERR,arg[iarg+2]); + iarg += 3; + } else if (strcmp(arg[iarg],"vz") == 0) { + if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); + vzlo = force->numeric(FLERR,arg[iarg+1]); + vzhi = force->numeric(FLERR,arg[iarg+2]); + iarg += 3; + } else if (strcmp(arg[iarg],"units") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); + if (strcmp(arg[iarg+1],"box") == 0) scaleflag = 0; + else if (strcmp(arg[iarg+1],"lattice") == 0) scaleflag = 1; + else error->all(FLERR,"Illegal fix deposit command"); + iarg += 2; + } else if (strcmp(arg[iarg],"gaussian") == 0) { + if (iarg+5 > narg) error->all(FLERR,"Illegal fix deposit command"); + xmid = force->numeric(FLERR,arg[iarg+1]); + ymid = force->numeric(FLERR,arg[iarg+2]); + zmid = force->numeric(FLERR,arg[iarg+3]); + sigma = force->numeric(FLERR,arg[iarg+4]); + distflag = DIST_GAUSSIAN; + iarg += 5; + } else if (strcmp(arg[iarg],"target") == 0) { + if (iarg+4 > narg) error->all(FLERR,"Illegal fix deposit command"); + tx = force->numeric(FLERR,arg[iarg+1]); + ty = force->numeric(FLERR,arg[iarg+2]); + tz = force->numeric(FLERR,arg[iarg+3]); + targetflag = 1; + iarg += 4; + } else error->all(FLERR,"Illegal fix deposit command"); + } +} + +/* ---------------------------------------------------------------------- + pack entire state of Fix into one write +------------------------------------------------------------------------- */ + +void FixDeposit::write_restart(FILE *fp) +{ + int n = 0; + double list[5]; + list[n++] = random->state(); + list[n++] = ninserted; + list[n++] = nfirst; + list[n++] = ubuf(next_reneighbor).d; + list[n++] = ubuf(update->ntimestep).d; + + if (comm->me == 0) { + int size = n * sizeof(double); + fwrite(&size,sizeof(int),1,fp); + fwrite(list,sizeof(double),n,fp); + } +} + +/* ---------------------------------------------------------------------- + use state info from restart file to restart the Fix +------------------------------------------------------------------------- */ + +void FixDeposit::restart(char *buf) +{ + int n = 0; + double *list = (double *) buf; + + seed = static_cast (list[n++]); + ninserted = static_cast (list[n++]); + nfirst = static_cast (list[n++]); + next_reneighbor = (bigint) ubuf(list[n++]).i; + + bigint ntimestep_restart = (bigint) ubuf(list[n++]).i; + if (ntimestep_restart != update->ntimestep) + error->all(FLERR,"Must not reset timestep when restarting this fix"); + + random->reset(seed); +} + +/* ---------------------------------------------------------------------- + extract particle radius for atom type = itype +------------------------------------------------------------------------- */ + +void *FixDeposit::extract(const char *str, int &itype) +{ + if (strcmp(str,"radius") == 0) { + if (mode == ATOM) { + if (itype == ntype) oneradius = 0.5; + else oneradius = 0.0; + + } else { + + // loop over onemols molecules + // skip a molecule with no atoms as large as itype + + oneradius = 0.0; + for (int i = 0; i < nmol; i++) { + if (itype > ntype+onemols[i]->ntypes) continue; + double *radius = onemols[i]->radius; + int *type = onemols[i]->type; + int natoms = onemols[i]->natoms; + + // check radii of atoms in Molecule with matching types + // default to 0.5, if radii not defined in Molecule + // same as atom->avec->create_atom(), invoked in pre_exchange() + + for (int i = 0; i < natoms; i++) + if (type[i]+ntype == itype) { + if (radius) oneradius = MAX(oneradius,radius[i]); + else oneradius = MAX(oneradius,0.5); + } + } + } + itype = 0; + return &oneradius; + } + + return NULL; +} From 19d7cd6364964daeb4564991f78c27a9cce575d1 Mon Sep 17 00:00:00 2001 From: Jun-Chieh Wang Date: Thu, 18 Jul 2019 09:00:30 -0700 Subject: [PATCH 043/557] git rm fix_deposit.cpp from /src --- src/fix_deposit.cpp | 880 -------------------------------------------- 1 file changed, 880 deletions(-) delete mode 100644 src/fix_deposit.cpp diff --git a/src/fix_deposit.cpp b/src/fix_deposit.cpp deleted file mode 100644 index ca841b49bd..0000000000 --- a/src/fix_deposit.cpp +++ /dev/null @@ -1,880 +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 -#include -#include "fix_deposit.h" -#include "atom.h" -#include "atom_vec.h" -#include "molecule.h" -#include "force.h" -#include "update.h" -#include "modify.h" -#include "fix.h" -#include "comm.h" -#include "domain.h" -#include "lattice.h" -#include "region.h" -#include "random_park.h" -#include "math_extra.h" -#include "math_const.h" -#include "memory.h" -#include "error.h" - -using namespace LAMMPS_NS; -using namespace FixConst; -using namespace MathConst; - -enum{ATOM,MOLECULE}; -enum{DIST_UNIFORM,DIST_GAUSSIAN}; - -#define EPSILON 1.0e6 - -/* ---------------------------------------------------------------------- */ - -FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg), idregion(NULL), idrigid(NULL), - idshake(NULL), onemols(NULL), molfrac(NULL), coords(NULL), imageflags(NULL), - fixrigid(NULL), fixshake(NULL), random(NULL) -{ - if (narg < 7) error->all(FLERR,"Illegal fix deposit command"); - - restart_global = 1; - time_depend = 1; - - // required args - - ninsert = force->inumeric(FLERR,arg[3]); - ntype = force->inumeric(FLERR,arg[4]); - nfreq = force->inumeric(FLERR,arg[5]); - seed = force->inumeric(FLERR,arg[6]); - - if (seed <= 0) error->all(FLERR,"Illegal fix deposit command"); - - // read options from end of input line - - options(narg-7,&arg[7]); - - // error check on type - - if (mode == ATOM && (ntype <= 0 || ntype > atom->ntypes)) - error->all(FLERR,"Invalid atom type in fix deposit command"); - - // error checks on region and its extent being inside simulation box - - if (iregion == -1) error->all(FLERR,"Must specify a region in fix deposit"); - if (domain->regions[iregion]->bboxflag == 0) - error->all(FLERR,"Fix deposit region does not support a bounding box"); - if (domain->regions[iregion]->dynamic_check()) - error->all(FLERR,"Fix deposit region cannot be dynamic"); - - xlo = domain->regions[iregion]->extent_xlo; - xhi = domain->regions[iregion]->extent_xhi; - ylo = domain->regions[iregion]->extent_ylo; - yhi = domain->regions[iregion]->extent_yhi; - zlo = domain->regions[iregion]->extent_zlo; - zhi = domain->regions[iregion]->extent_zhi; - - if (domain->triclinic == 0) { - if (xlo < domain->boxlo[0] || xhi > domain->boxhi[0] || - ylo < domain->boxlo[1] || yhi > domain->boxhi[1] || - zlo < domain->boxlo[2] || zhi > domain->boxhi[2]) - error->all(FLERR,"Deposition region extends outside simulation box"); - } else { - if (xlo < domain->boxlo_bound[0] || xhi > domain->boxhi_bound[0] || - ylo < domain->boxlo_bound[1] || yhi > domain->boxhi_bound[1] || - zlo < domain->boxlo_bound[2] || zhi > domain->boxhi_bound[2]) - error->all(FLERR,"Deposition region extends outside simulation box"); - } - - // error check and further setup for mode = MOLECULE - - if (atom->tag_enable == 0) - error->all(FLERR,"Cannot use fix_deposit unless atoms have IDs"); - - if (mode == MOLECULE) { - for (int i = 0; i < nmol; i++) { - if (onemols[i]->xflag == 0) - error->all(FLERR,"Fix deposit molecule must have coordinates"); - if (onemols[i]->typeflag == 0) - error->all(FLERR,"Fix deposit molecule must have atom types"); - if (ntype+onemols[i]->ntypes <= 0 || - ntype+onemols[i]->ntypes > atom->ntypes) - error->all(FLERR,"Invalid atom type in fix deposit mol command"); - - if (atom->molecular == 2 && onemols != atom->avec->onemols) - error->all(FLERR,"Fix deposit molecule template ID must be same " - "as atom_style template ID"); - onemols[i]->check_attributes(0); - - // fix deposit uses geoemetric center of molecule for insertion - - onemols[i]->compute_center(); - } - } - - if (rigidflag && mode == ATOM) - error->all(FLERR,"Cannot use fix deposit rigid and not molecule"); - if (shakeflag && mode == ATOM) - error->all(FLERR,"Cannot use fix deposit shake and not molecule"); - if (rigidflag && shakeflag) - error->all(FLERR,"Cannot use fix deposit rigid and shake"); - - // setup of coords and imageflags array - - if (mode == ATOM) natom_max = 1; - else { - natom_max = 0; - for (int i = 0; i < nmol; i++) - natom_max = MAX(natom_max,onemols[i]->natoms); - } - memory->create(coords,natom_max,3,"deposit:coords"); - memory->create(imageflags,natom_max,"deposit:imageflags"); - - // setup scaling - - double xscale,yscale,zscale; - if (scaleflag) { - xscale = domain->lattice->xlattice; - yscale = domain->lattice->ylattice; - zscale = domain->lattice->zlattice; - } - else xscale = yscale = zscale = 1.0; - - // apply scaling to all input parameters with dist/vel units - - if (domain->dimension == 2) { - lo *= yscale; - hi *= yscale; - rate *= yscale; - } else { - lo *= zscale; - hi *= zscale; - rate *= zscale; - } - deltasq *= xscale*xscale; - nearsq *= xscale*xscale; - vxlo *= xscale; - vxhi *= xscale; - vylo *= yscale; - vyhi *= yscale; - vzlo *= zscale; - vzhi *= zscale; - xmid *= xscale; - ymid *= yscale; - zmid *= zscale; - sigma *= xscale; // same as in region sphere - tx *= xscale; - ty *= yscale; - tz *= zscale; - - // find current max atom and molecule IDs if necessary - - if (idnext) find_maxid(); - - // random number generator, same for all procs - - random = new RanPark(lmp,seed); - - // set up reneighboring - - force_reneighbor = 1; - next_reneighbor = update->ntimestep + 1; - nfirst = next_reneighbor; - ninserted = 0; -} - -/* ---------------------------------------------------------------------- */ - -FixDeposit::~FixDeposit() -{ - delete random; - delete [] molfrac; - delete [] idrigid; - delete [] idshake; - delete [] idregion; - memory->destroy(coords); - memory->destroy(imageflags); -} - -/* ---------------------------------------------------------------------- */ - -int FixDeposit::setmask() -{ - int mask = 0; - mask |= PRE_EXCHANGE; - return mask; -} - -/* ---------------------------------------------------------------------- */ - -void FixDeposit::init() -{ - // set index and check validity of region - - iregion = domain->find_region(idregion); - if (iregion == -1) - error->all(FLERR,"Region ID for fix deposit does not exist"); - - // if rigidflag defined, check for rigid/small fix - // its molecule template must be same as this one - - fixrigid = NULL; - if (rigidflag) { - int ifix = modify->find_fix(idrigid); - if (ifix < 0) error->all(FLERR,"Fix deposit rigid fix does not exist"); - fixrigid = modify->fix[ifix]; - int tmp; - if (onemols != (Molecule **) fixrigid->extract("onemol",tmp)) - error->all(FLERR, - "Fix deposit and fix rigid/small not using " - "same molecule template ID"); - } - - // if shakeflag defined, check for SHAKE fix - // its molecule template must be same as this one - - fixshake = NULL; - if (shakeflag) { - int ifix = modify->find_fix(idshake); - if (ifix < 0) error->all(FLERR,"Fix deposit shake fix does not exist"); - fixshake = modify->fix[ifix]; - int tmp; - if (onemols != (Molecule **) fixshake->extract("onemol",tmp)) - error->all(FLERR,"Fix deposit and fix shake not using " - "same molecule template ID"); - } - - // for finite size spherical particles: - // warn if near < 2 * maxrad of existing and inserted particles - // since may lead to overlaps - // if inserted molecule does not define diameters, - // use AtomVecSphere::create_atom() default radius = 0.5 - - if (atom->radius_flag) { - double *radius = atom->radius; - int nlocal = atom->nlocal; - - double maxrad = 0.0; - for (int i = 0; i < nlocal; i++) - maxrad = MAX(maxrad,radius[i]); - - double maxradall; - MPI_Allreduce(&maxrad,&maxradall,1,MPI_DOUBLE,MPI_MAX,world); - - double maxradinsert = 0.0; - if (mode == MOLECULE) { - for (int i = 0; i < nmol; i++) { - if (onemols[i]->radiusflag) - maxradinsert = MAX(maxradinsert,onemols[i]->maxradius); - else maxradinsert = MAX(maxradinsert,0.5); - } - } else maxradinsert = 0.5; - - double separation = MAX(2.0*maxradinsert,maxradall+maxradinsert); - if (sqrt(nearsq) < separation && comm->me == 0) { - char str[128]; - sprintf(str,"Fix deposit near setting < possible overlap separation %g", - separation); - error->warning(FLERR,str); - } - } -} - -/* ---------------------------------------------------------------------- - perform particle insertion -------------------------------------------------------------------------- */ - -void FixDeposit::pre_exchange() -{ - int i,m,n,nlocalprev,imol,natom,flag,flagall; - double coord[3],lamda[3],delx,dely,delz,rsq; - double r[3],vnew[3],rotmat[3][3],quat[4]; - double *newcoord; - - // just return if should not be called on this timestep - - if (next_reneighbor != update->ntimestep) return; - - // clear ghost count and any ghost bonus data internal to AtomVec - // same logic as beginning of Comm::exchange() - // do it now b/c inserting atoms will overwrite ghost atoms - - atom->nghost = 0; - atom->avec->clear_bonus(); - - // compute current offset = bottom of insertion volume - - double offset = 0.0; - if (rateflag) offset = (update->ntimestep - nfirst) * update->dt * rate; - - double *sublo,*subhi; - if (domain->triclinic == 0) { - sublo = domain->sublo; - subhi = domain->subhi; - } else { - sublo = domain->sublo_lamda; - subhi = domain->subhi_lamda; - } - - // find current max atom and molecule IDs if necessary - - if (!idnext) find_maxid(); - - // attempt an insertion until successful - - int dimension = domain->dimension; - - int success = 0; - int attempt = 0; - while (attempt < maxattempt) { - attempt++; - - // choose random position for new particle within region - if (distflag == DIST_UNIFORM) { - // throw away the first few numbers to avoid the unexpected correlations - double tmp_rand; - for (int ii=0; ii < 30; ii++) { - tmp_rand = random->uniform(); - } - do { - coord[0] = xlo + random->uniform() * (xhi-xlo); - coord[1] = ylo + random->uniform() * (yhi-ylo); - coord[2] = zlo + random->uniform() * (zhi-zlo); - } while (domain->regions[iregion]->match(coord[0],coord[1],coord[2]) == 0); - } else if (distflag == DIST_GAUSSIAN) { - do { - coord[0] = xmid + random->gaussian() * sigma; - coord[1] = ymid + random->gaussian() * sigma; - coord[2] = zmid + random->gaussian() * sigma; - } while (domain->regions[iregion]->match(coord[0],coord[1],coord[2]) == 0); - } else error->all(FLERR,"Unknown particle distribution in fix deposit"); - - // adjust vertical coord by offset - - if (dimension == 2) coord[1] += offset; - else coord[2] += offset; - - // if global, reset vertical coord to be lo-hi above highest atom - // if local, reset vertical coord to be lo-hi above highest "nearby" atom - // local computation computes lateral distance between 2 particles w/ PBC - // when done, have final coord of atom or center pt of molecule - - if (globalflag || localflag) { - int dim; - double max,maxall,delx,dely,delz,rsq; - - if (dimension == 2) { - dim = 1; - max = domain->boxlo[1]; - } else { - dim = 2; - max = domain->boxlo[2]; - } - - double **x = atom->x; - int nlocal = atom->nlocal; - for (i = 0; i < nlocal; i++) { - if (localflag) { - delx = coord[0] - x[i][0]; - dely = coord[1] - x[i][1]; - delz = 0.0; - domain->minimum_image(delx,dely,delz); - if (dimension == 2) rsq = delx*delx; - else rsq = delx*delx + dely*dely; - if (rsq > deltasq) continue; - } - if (x[i][dim] > max) max = x[i][dim]; - } - - MPI_Allreduce(&max,&maxall,1,MPI_DOUBLE,MPI_MAX,world); - if (dimension == 2) - coord[1] = maxall + lo + random->uniform()*(hi-lo); - else - coord[2] = maxall + lo + random->uniform()*(hi-lo); - } - - // coords = coords of all atoms - // for molecule, perform random rotation around center pt - // apply PBC so final coords are inside box - // also modify image flags due to PBC - - if (mode == ATOM) { - natom = 1; - coords[0][0] = coord[0]; - coords[0][1] = coord[1]; - coords[0][2] = coord[2]; - imageflags[0] = ((imageint) IMGMAX << IMG2BITS) | - ((imageint) IMGMAX << IMGBITS) | IMGMAX; - } else { - double rng = random->uniform(); - imol = 0; - while (rng > molfrac[imol]) imol++; - natom = onemols[imol]->natoms; - if (dimension == 3) { - r[0] = random->uniform() - 0.5; - r[1] = random->uniform() - 0.5; - r[2] = random->uniform() - 0.5; - } else { - r[0] = r[1] = 0.0; - r[2] = 1.0; - } - double theta = random->uniform() * MY_2PI; - MathExtra::norm3(r); - MathExtra::axisangle_to_quat(r,theta,quat); - MathExtra::quat_to_mat(quat,rotmat); - for (i = 0; i < natom; i++) { - MathExtra::matvec(rotmat,onemols[imol]->dx[i],coords[i]); - coords[i][0] += coord[0]; - coords[i][1] += coord[1]; - coords[i][2] += coord[2]; - - imageflags[i] = ((imageint) IMGMAX << IMG2BITS) | - ((imageint) IMGMAX << IMGBITS) | IMGMAX; - domain->remap(coords[i],imageflags[i]); - } - } - - // check distance between any existing atom and any inserted atom - // if less than near, try again - // use minimum_image() to account for PBC - - double **x = atom->x; - int nlocal = atom->nlocal; - - flag = 0; - for (m = 0; m < natom; m++) { - for (i = 0; i < nlocal; i++) { - delx = coords[m][0] - x[i][0]; - dely = coords[m][1] - x[i][1]; - delz = coords[m][2] - x[i][2]; - domain->minimum_image(delx,dely,delz); - rsq = delx*delx + dely*dely + delz*delz; - if (rsq < nearsq) flag = 1; - } - } - MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_MAX,world); - if (flagall) continue; - - // proceed with insertion - - nlocalprev = atom->nlocal; - - // choose random velocity for new particle - // used for every atom in molecule - - vnew[0] = vxlo + random->uniform() * (vxhi-vxlo); - vnew[1] = vylo + random->uniform() * (vyhi-vylo); - vnew[2] = vzlo + random->uniform() * (vzhi-vzlo); - - // if target specified, change velocity vector accordingly - - if (targetflag) { - double vel = sqrt(vnew[0]*vnew[0] + vnew[1]*vnew[1] + vnew[2]*vnew[2]); - delx = tx - coord[0]; - dely = ty - coord[1]; - delz = tz - coord[2]; - double rsq = delx*delx + dely*dely + delz*delz; - if (rsq > 0.0) { - double rinv = sqrt(1.0/rsq); - vnew[0] = delx*rinv*vel; - vnew[1] = dely*rinv*vel; - vnew[2] = delz*rinv*vel; - } - } - - // check if new atoms are in my sub-box or above it if I am highest proc - // if so, add atom to my list via create_atom() - // initialize additional info about the atoms - // set group mask to "all" plus fix group - - for (m = 0; m < natom; m++) { - if (domain->triclinic) { - domain->x2lamda(coords[m],lamda); - newcoord = lamda; - } else newcoord = coords[m]; - - flag = 0; - if (newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && - newcoord[1] >= sublo[1] && newcoord[1] < subhi[1] && - newcoord[2] >= sublo[2] && newcoord[2] < subhi[2]) flag = 1; - else if (dimension == 3 && newcoord[2] >= domain->boxhi[2]) { - if (comm->layout != Comm::LAYOUT_TILED) { - if (comm->myloc[2] == comm->procgrid[2]-1 && - newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && - newcoord[1] >= sublo[1] && newcoord[1] < subhi[1]) flag = 1; - } else { - if (comm->mysplit[2][1] == 1.0 && - newcoord[0] >= sublo[0] && newcoord[0] < subhi[0] && - newcoord[1] >= sublo[1] && newcoord[1] < subhi[1]) flag = 1; - } - } else if (dimension == 2 && newcoord[1] >= domain->boxhi[1]) { - if (comm->layout != Comm::LAYOUT_TILED) { - if (comm->myloc[1] == comm->procgrid[1]-1 && - newcoord[0] >= sublo[0] && newcoord[0] < subhi[0]) flag = 1; - } else { - if (comm->mysplit[1][1] == 1.0 && - newcoord[0] >= sublo[0] && newcoord[0] < subhi[0]) flag = 1; - } - } - - if (flag) { - if (mode == ATOM) atom->avec->create_atom(ntype,coords[m]); - else atom->avec->create_atom(ntype+onemols[imol]->type[m],coords[m]); - n = atom->nlocal - 1; - atom->tag[n] = maxtag_all + m+1; - if (mode == MOLECULE) { - if (atom->molecule_flag) atom->molecule[n] = maxmol_all+1; - if (atom->molecular == 2) { - atom->molindex[n] = 0; - atom->molatom[n] = m; - } - } - atom->mask[n] = 1 | groupbit; - atom->image[n] = imageflags[m]; - atom->v[n][0] = vnew[0]; - atom->v[n][1] = vnew[1]; - atom->v[n][2] = vnew[2]; - if (mode == MOLECULE) { - onemols[imol]->quat_external = quat; - atom->add_molecule_atom(onemols[imol],m,n,maxtag_all); - } - modify->create_attribute(n); - } - } - - // FixRigidSmall::set_molecule stores rigid body attributes - // coord is new position of geometric center of mol, not COM - // FixShake::set_molecule stores shake info for molecule - - if (rigidflag) - fixrigid->set_molecule(nlocalprev,maxtag_all,imol,coord,vnew,quat); - else if (shakeflag) - fixshake->set_molecule(nlocalprev,maxtag_all,imol,coord,vnew,quat); - - // old code: unsuccessful if no proc performed insertion of an atom - // don't think that check is necessary - // if get this far, should always be succesful - // would be hard to undo partial insertion for a molecule - // better to check how many atoms could be inserted (w/out inserting) - // then sum to insure all are inserted, before doing actual insertion - // MPI_Allreduce(&flag,&success,1,MPI_INT,MPI_MAX,world); - - success = 1; - break; - } - - // warn if not successful b/c too many attempts - - if (!success && comm->me == 0) - error->warning(FLERR,"Particle deposition was unsuccessful",0); - - // reset global natoms,nbonds,etc - // increment maxtag_all and maxmol_all if necessary - // if global map exists, reset it now instead of waiting for comm - // since other pre-exchange fixes may use it - // invoke map_init() b/c atom count has grown - - if (success) { - atom->natoms += natom; - if (atom->natoms < 0) - error->all(FLERR,"Too many total atoms"); - if (mode == MOLECULE) { - atom->nbonds += onemols[imol]->nbonds; - atom->nangles += onemols[imol]->nangles; - atom->ndihedrals += onemols[imol]->ndihedrals; - atom->nimpropers += onemols[imol]->nimpropers; - } - maxtag_all += natom; - if (maxtag_all >= MAXTAGINT) - error->all(FLERR,"New atom IDs exceed maximum allowed ID"); - if (mode == MOLECULE && atom->molecule_flag) maxmol_all++; - if (atom->map_style) { - atom->map_init(); - atom->map_set(); - } - } - - // next timestep to insert - // next_reneighbor = 0 if done - - if (success) ninserted++; - if (ninserted < ninsert) next_reneighbor += nfreq; - else next_reneighbor = 0; -} - -/* ---------------------------------------------------------------------- - maxtag_all = current max atom ID for all atoms - maxmol_all = current max molecule ID for all atoms -------------------------------------------------------------------------- */ - -void FixDeposit::find_maxid() -{ - tagint *tag = atom->tag; - tagint *molecule = atom->molecule; - int nlocal = atom->nlocal; - - tagint max = 0; - for (int i = 0; i < nlocal; i++) max = MAX(max,tag[i]); - MPI_Allreduce(&max,&maxtag_all,1,MPI_LMP_TAGINT,MPI_MAX,world); - - if (mode == MOLECULE && molecule) { - max = 0; - for (int i = 0; i < nlocal; i++) max = MAX(max,molecule[i]); - MPI_Allreduce(&max,&maxmol_all,1,MPI_LMP_TAGINT,MPI_MAX,world); - } -} - -/* ---------------------------------------------------------------------- - parse optional parameters at end of input line -------------------------------------------------------------------------- */ - -void FixDeposit::options(int narg, char **arg) -{ - // defaults - - iregion = -1; - idregion = NULL; - mode = ATOM; - molfrac = NULL; - rigidflag = 0; - idrigid = NULL; - shakeflag = 0; - idshake = NULL; - idnext = 0; - globalflag = localflag = 0; - lo = hi = deltasq = 0.0; - nearsq = 0.0; - maxattempt = 10; - rateflag = 0; - vxlo = vxhi = vylo = vyhi = vzlo = vzhi = 0.0; - distflag = DIST_UNIFORM; - sigma = 1.0; - xmid = ymid = zmid = 0.0; - scaleflag = 1; - targetflag = 0; - - int iarg = 0; - while (iarg < narg) { - if (strcmp(arg[iarg],"region") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - iregion = domain->find_region(arg[iarg+1]); - if (iregion == -1) - error->all(FLERR,"Region ID for fix deposit does not exist"); - int n = strlen(arg[iarg+1]) + 1; - idregion = new char[n]; - strcpy(idregion,arg[iarg+1]); - iarg += 2; - - } else if (strcmp(arg[iarg],"mol") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - int imol = atom->find_molecule(arg[iarg+1]); - if (imol == -1) - error->all(FLERR,"Molecule template ID for fix deposit does not exist"); - mode = MOLECULE; - onemols = &atom->molecules[imol]; - nmol = onemols[0]->nset; - delete [] molfrac; - molfrac = new double[nmol]; - molfrac[0] = 1.0/nmol; - for (int i = 1; i < nmol-1; i++) molfrac[i] = molfrac[i-1] + 1.0/nmol; - molfrac[nmol-1] = 1.0; - iarg += 2; - } else if (strcmp(arg[iarg],"molfrac") == 0) { - if (mode != MOLECULE) error->all(FLERR,"Illegal fix deposit command"); - if (iarg+nmol+1 > narg) error->all(FLERR,"Illegal fix deposit command"); - molfrac[0] = force->numeric(FLERR,arg[iarg+1]); - for (int i = 1; i < nmol; i++) - molfrac[i] = molfrac[i-1] + force->numeric(FLERR,arg[iarg+i+1]); - if (molfrac[nmol-1] < 1.0-EPSILON || molfrac[nmol-1] > 1.0+EPSILON) - error->all(FLERR,"Illegal fix deposit command"); - molfrac[nmol-1] = 1.0; - iarg += nmol+1; - - } else if (strcmp(arg[iarg],"rigid") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - int n = strlen(arg[iarg+1]) + 1; - delete [] idrigid; - idrigid = new char[n]; - strcpy(idrigid,arg[iarg+1]); - rigidflag = 1; - iarg += 2; - } else if (strcmp(arg[iarg],"shake") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - int n = strlen(arg[iarg+1]) + 1; - delete [] idshake; - idshake = new char[n]; - strcpy(idshake,arg[iarg+1]); - shakeflag = 1; - iarg += 2; - - } else if (strcmp(arg[iarg],"id") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - if (strcmp(arg[iarg+1],"max") == 0) idnext = 0; - else if (strcmp(arg[iarg+1],"next") == 0) idnext = 1; - else error->all(FLERR,"Illegal fix deposit command"); - iarg += 2; - } else if (strcmp(arg[iarg],"global") == 0) { - if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); - globalflag = 1; - localflag = 0; - lo = force->numeric(FLERR,arg[iarg+1]); - hi = force->numeric(FLERR,arg[iarg+2]); - iarg += 3; - } else if (strcmp(arg[iarg],"local") == 0) { - if (iarg+4 > narg) error->all(FLERR,"Illegal fix deposit command"); - localflag = 1; - globalflag = 0; - lo = force->numeric(FLERR,arg[iarg+1]); - hi = force->numeric(FLERR,arg[iarg+2]); - deltasq = force->numeric(FLERR,arg[iarg+3]) * - force->numeric(FLERR,arg[iarg+3]); - iarg += 4; - - } else if (strcmp(arg[iarg],"near") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - nearsq = force->numeric(FLERR,arg[iarg+1]) * - force->numeric(FLERR,arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"attempt") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - maxattempt = force->inumeric(FLERR,arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"rate") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - rateflag = 1; - rate = force->numeric(FLERR,arg[iarg+1]); - iarg += 2; - } else if (strcmp(arg[iarg],"vx") == 0) { - if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); - vxlo = force->numeric(FLERR,arg[iarg+1]); - vxhi = force->numeric(FLERR,arg[iarg+2]); - iarg += 3; - } else if (strcmp(arg[iarg],"vy") == 0) { - if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); - vylo = force->numeric(FLERR,arg[iarg+1]); - vyhi = force->numeric(FLERR,arg[iarg+2]); - iarg += 3; - } else if (strcmp(arg[iarg],"vz") == 0) { - if (iarg+3 > narg) error->all(FLERR,"Illegal fix deposit command"); - vzlo = force->numeric(FLERR,arg[iarg+1]); - vzhi = force->numeric(FLERR,arg[iarg+2]); - iarg += 3; - } else if (strcmp(arg[iarg],"units") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix deposit command"); - if (strcmp(arg[iarg+1],"box") == 0) scaleflag = 0; - else if (strcmp(arg[iarg+1],"lattice") == 0) scaleflag = 1; - else error->all(FLERR,"Illegal fix deposit command"); - iarg += 2; - } else if (strcmp(arg[iarg],"gaussian") == 0) { - if (iarg+5 > narg) error->all(FLERR,"Illegal fix deposit command"); - xmid = force->numeric(FLERR,arg[iarg+1]); - ymid = force->numeric(FLERR,arg[iarg+2]); - zmid = force->numeric(FLERR,arg[iarg+3]); - sigma = force->numeric(FLERR,arg[iarg+4]); - distflag = DIST_GAUSSIAN; - iarg += 5; - } else if (strcmp(arg[iarg],"target") == 0) { - if (iarg+4 > narg) error->all(FLERR,"Illegal fix deposit command"); - tx = force->numeric(FLERR,arg[iarg+1]); - ty = force->numeric(FLERR,arg[iarg+2]); - tz = force->numeric(FLERR,arg[iarg+3]); - targetflag = 1; - iarg += 4; - } else error->all(FLERR,"Illegal fix deposit command"); - } -} - -/* ---------------------------------------------------------------------- - pack entire state of Fix into one write -------------------------------------------------------------------------- */ - -void FixDeposit::write_restart(FILE *fp) -{ - int n = 0; - double list[5]; - list[n++] = random->state(); - list[n++] = ninserted; - list[n++] = nfirst; - list[n++] = ubuf(next_reneighbor).d; - list[n++] = ubuf(update->ntimestep).d; - - if (comm->me == 0) { - int size = n * sizeof(double); - fwrite(&size,sizeof(int),1,fp); - fwrite(list,sizeof(double),n,fp); - } -} - -/* ---------------------------------------------------------------------- - use state info from restart file to restart the Fix -------------------------------------------------------------------------- */ - -void FixDeposit::restart(char *buf) -{ - int n = 0; - double *list = (double *) buf; - - seed = static_cast (list[n++]); - ninserted = static_cast (list[n++]); - nfirst = static_cast (list[n++]); - next_reneighbor = (bigint) ubuf(list[n++]).i; - - bigint ntimestep_restart = (bigint) ubuf(list[n++]).i; - if (ntimestep_restart != update->ntimestep) - error->all(FLERR,"Must not reset timestep when restarting this fix"); - - random->reset(seed); -} - -/* ---------------------------------------------------------------------- - extract particle radius for atom type = itype -------------------------------------------------------------------------- */ - -void *FixDeposit::extract(const char *str, int &itype) -{ - if (strcmp(str,"radius") == 0) { - if (mode == ATOM) { - if (itype == ntype) oneradius = 0.5; - else oneradius = 0.0; - - } else { - - // loop over onemols molecules - // skip a molecule with no atoms as large as itype - - oneradius = 0.0; - for (int i = 0; i < nmol; i++) { - if (itype > ntype+onemols[i]->ntypes) continue; - double *radius = onemols[i]->radius; - int *type = onemols[i]->type; - int natoms = onemols[i]->natoms; - - // check radii of atoms in Molecule with matching types - // default to 0.5, if radii not defined in Molecule - // same as atom->avec->create_atom(), invoked in pre_exchange() - - for (int i = 0; i < natoms; i++) - if (type[i]+ntype == itype) { - if (radius) oneradius = MAX(oneradius,radius[i]); - else oneradius = MAX(oneradius,0.5); - } - } - } - itype = 0; - return &oneradius; - } - - return NULL; -} From 3bc2a5504b7f43991d241ad839c5f668c58b7221 Mon Sep 17 00:00:00 2001 From: Jun-Chieh Wang Date: Thu, 18 Jul 2019 09:04:44 -0700 Subject: [PATCH 044/557] throw away random numbers in /src/MISC/fix_deposit.cpp --- src/MISC/fix_deposit.cpp | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index 66aed34846..ca841b49bd 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -343,6 +343,11 @@ void FixDeposit::pre_exchange() // choose random position for new particle within region if (distflag == DIST_UNIFORM) { + // throw away the first few numbers to avoid the unexpected correlations + double tmp_rand; + for (int ii=0; ii < 30; ii++) { + tmp_rand = random->uniform(); + } do { coord[0] = xlo + random->uniform() * (xhi-xlo); coord[1] = ylo + random->uniform() * (yhi-ylo); From 45516e329eaa69686823b26394541c077068f9f2 Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 09:30:02 +0000 Subject: [PATCH 045/557] delete unused variables and function --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 174 ++++++++++------------------- src/SPIN/min_spin_oso_lbfgs_ls.h | 15 +-- 2 files changed, 62 insertions(+), 127 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index e1a6ae99d5..5896ba9a9f 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -75,6 +75,7 @@ MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; + use_line_search = 1; } @@ -88,24 +89,21 @@ MinSpinOSO_LBFGS_LS::~MinSpinOSO_LBFGS_LS() memory->destroy(ds); memory->destroy(dy); memory->destroy(rho); - memory->destroy(sp_copy); + if (use_line_search) + memory->destroy(sp_copy); } /* ---------------------------------------------------------------------- */ void MinSpinOSO_LBFGS_LS::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; num_mem = 3; local_iter = 0; der_e_cur = 0.0; der_e_pr = 0.0; - use_line_search = 1; Min::init(); - dts = dt = update->dt; last_negative = update->ntimestep; // allocate tables @@ -117,7 +115,8 @@ void MinSpinOSO_LBFGS_LS::init() memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); } @@ -141,14 +140,10 @@ void MinSpinOSO_LBFGS_LS::setup_style() int MinSpinOSO_LBFGS_LS::modify_param(int narg, char **arg) { - if (strcmp(arg[0],"alpha_damp") == 0) { + + if (strcmp(arg[0],"line_search") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - alpha_damp = force->numeric(FLERR,arg[1]); - return 2; - } - if (strcmp(arg[0],"discrete_factor") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - discrete_factor = force->numeric(FLERR,arg[1]); + use_line_search = force->numeric(FLERR,arg[1]); return 2; } return 0; @@ -185,7 +180,7 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) double fmdotfm; int flag, flagall; double **sp = atom->sp; - double der_e_cur_global = 0.0; + double der_e_cur_tmp = 0.0; if (nlocal_max < nlocal) { nlocal_max = nlocal; @@ -195,7 +190,8 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); } for (int iter = 0; iter < maxiter; iter++) { @@ -211,34 +207,35 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) if (local_iter == 0){ ecurrent = energy_force(0); - calc_gradient(1.0); + calc_gradient(); neval++; } calc_search_direction(); if (use_line_search) { + + // here we need to do line search + der_e_cur = 0.0; for (int i = 0; i < 3 * nlocal; i++) { der_e_cur += g_cur[i] * p_s[i]; } - MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); - der_e_cur = der_e_cur_global; + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_global,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - } - - if (use_line_search){ - // here we need to do line search for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++) sp_copy[i][j] = sp[i][j]; } eprevious = ecurrent; der_e_pr = der_e_cur; - calc_and_make_step(0.0, 1.0, 0); } else{ + + // here we don't do line search + advance_spins(); eprevious = ecurrent; ecurrent = energy_force(0); @@ -291,56 +288,11 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) return MAXITER; } -/* ---------------------------------------------------------------------- - evaluate max timestep ----------------------------------------------------------------------- */ - -double MinSpinOSO_LBFGS_LS::evaluate_dt() -{ - double dtmax; - double fmsq; - double fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double **fm = atom->fm; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - if (fmaxsqall == 0.0) - error->all(FLERR,"Incorrect fmaxsqall calculation"); - - // define max timestep by dividing by the - // inverse of max frequency by discrete_factor - - dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); - - return dtmax; -} - /* ---------------------------------------------------------------------- calculate gradients ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS_LS::calc_gradient(double dts) +void MinSpinOSO_LBFGS_LS::calc_gradient() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -351,17 +303,11 @@ void MinSpinOSO_LBFGS_LS::calc_gradient(double dts) for (int i = 0; i < nlocal; i++) { - // calc. damping torque - - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - // calculate gradients - g_cur[3 * i + 0] = -tdampz * dts; - g_cur[3 * i + 1] = tdampy * dts; - g_cur[3 * i + 2] = -tdampx * dts; + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); } } @@ -438,7 +384,7 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() if (rho[m_index] < 0.0){ local_iter = 0; for (int k = 0; k < num_mem; k++){ - for (int i = 0; i < nlocal; i ++){ + for (int i = 0; i < nlocal; i ++){ ds[k][i] = 0.0; dy[k][i] = 0.0; } @@ -464,7 +410,7 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() for (int i = 0; i < 3 * nlocal; i++) { sq += ds[c_ind][i] * q[i]; } - MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { sq_global *= factor; sq = sq_global; @@ -487,7 +433,7 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() for (int i = 0; i < 3 * nlocal; i++) { yy += dy[m_index][i] * dy[m_index][i]; } - MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { yy_global *= factor; yy = yy_global; @@ -520,7 +466,7 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() yr += dy[c_ind][i] * p_s[i]; } - MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { yr_global *= factor; yr = yr_global; @@ -580,15 +526,11 @@ double MinSpinOSO_LBFGS_LS::fmnorm_sqr() double **sp = atom->sp; double **fm = atom->fm; - // calc. magnetic torques + // calc. magnetic torques norm double local_norm2_sqr = 0.0; - for (int i = 0; i < nlocal; i++) { - tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - local_norm2_sqr += tx*tx + ty*ty + tz*tz; + for (int i = 0; i < 3 * nlocal; i++) { + local_norm2_sqr += g_cur[i]*g_cur[i]; } // no extra atom calc. for spins @@ -678,9 +620,8 @@ void MinSpinOSO_LBFGS_LS::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ out[i] *= 0.0; - for(int j = 0; j < 3; j++){ - out[i] += *(m + 3 * j + i) * v[j]; - } + for(int j = 0; j < 3; j++) + out[i] += *(m + 3 * j + i) * v[j]; } } @@ -692,9 +633,10 @@ void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; double **sp = atom->sp; - double der_e_cur_global = 0.0;; + double der_e_cur_tmp = 0.0;; for (int i = 0; i < nlocal; i++) { + // scale the search direction for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; @@ -707,23 +649,23 @@ void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) vm3(rot_mat, sp[i], s_new); for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } + } - ecurrent = energy_force(0); - calc_gradient(1.0); - neval++; - der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - der_e_cur += g_cur[i] * p_s[i]; - } - MPI_Allreduce(&der_e_cur, &der_e_cur_global, 1, MPI_DOUBLE, MPI_SUM, world); - der_e_cur = der_e_cur_global; - if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_global,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } + ecurrent = energy_force(0); + calc_gradient(); + neval++; + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp, 1, MPI_DOUBLE, MPI_SUM, world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } - energy_and_der[0] = ecurrent; - energy_and_der[1] = der_e_cur; + energy_and_der[0] = ecurrent; + energy_and_der[1] = der_e_cur; } /* ---------------------------------------------------------------------- @@ -733,17 +675,17 @@ void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) { - double e_and_d[2] = {0.0, 0.0}; - double alpha, c1, c2, c3; + double e_and_d[2] = {0.0,0.0}; + double alpha,c1,c2,c3; double **sp = atom->sp; int nlocal = atom->nlocal; - make_step(b, e_and_d); + make_step(b,e_and_d); ecurrent = e_and_d[0]; der_e_cur = e_and_d[1]; index++; - if (awc(der_e_pr, eprevious, e_and_d[1], e_and_d[0]) || index == 5){ + if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 5){ MPI_Bcast(&b,1,MPI_DOUBLE,0,world); for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = b * p_s[i]; @@ -751,7 +693,7 @@ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) return 1; } else{ - double r, f0, f1, df0, df1; + double r,f0,f1,df0,df1; r = b - a; f0 = eprevious; f1 = ecurrent; @@ -778,18 +720,20 @@ int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) return 0; } + /* ---------------------------------------------------------------------- Approximate Wolfe conditions: William W. Hager and Hongchao Zhang SIAM J. optim., 16(1), 170-192. (23 pages) ------------------------------------------------------------------------- */ + int MinSpinOSO_LBFGS_LS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ double eps = 1.0e-6; double delta = 0.1; double sigma = 0.9; - if ((phi_j <= phi_0 + eps * fabs(phi_0)) && ((2.0*delta - 1.0) * der_phi_0 >= der_phi_j >= sigma * der_phi_0)) + if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.h b/src/SPIN/min_spin_oso_lbfgs_ls.h index eeaf20adf4..876e34f9c9 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.h +++ b/src/SPIN/min_spin_oso_lbfgs_ls.h @@ -34,24 +34,15 @@ public: int modify_param(int, char **); void reset_vectors(); int iterate(int); - double evaluate_dt(); void advance_spins(); double fmnorm_sqr(); - void calc_gradient(double); + void calc_gradient(); void calc_search_direction(); private: - // test - int ireplica,nreplica; - - // global and spin timesteps + int ireplica,nreplica; // for neb int nlocal_max; // max value of nlocal (for size of lists) - double dt; - double dts; - - double alpha_damp; // damping for spin minimization - double discrete_factor; // factor for spin timestep evaluation double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector @@ -65,7 +56,7 @@ private: double **sp_copy; // copy of the spins int num_mem; // number of stored steps - int local_iter; + int local_iter; // for neb double der_e_cur; // current derivative along search dir. double der_e_pr; // previous derivative along search dir. From 7514eea9a7112a3962ff208178570125e4d9bb4c Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 11:47:24 +0000 Subject: [PATCH 046/557] no line search option too --- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 115 ++++++++++++++++++++--------- src/SPIN/min_spin_oso_lbfgs_ls.h | 6 +- 2 files changed, 83 insertions(+), 38 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp index 5896ba9a9f..ddacd3e207 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ b/src/SPIN/min_spin_oso_lbfgs_ls.cpp @@ -76,6 +76,7 @@ MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; use_line_search = 1; + maxepsrot = MY_2PI / (100.0); } @@ -146,6 +147,13 @@ int MinSpinOSO_LBFGS_LS::modify_param(int narg, char **arg) use_line_search = force->numeric(FLERR,arg[1]); return 2; } + if (strcmp(arg[0],"discrete_factor") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + double discrete_factor; + discrete_factor = force->numeric(FLERR,arg[1]); + maxepsrot = MY_2PI / discrete_factor; + return 2; + } return 0; } @@ -184,6 +192,7 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) if (nlocal_max < nlocal) { nlocal_max = nlocal; + local_iter = 0; memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_old"); memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_cur"); memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs_ls:p_s"); @@ -195,7 +204,7 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) } for (int iter = 0; iter < maxiter; iter++) { - + if (timer->check_timeout(niter)) return TIMEOUT; @@ -205,17 +214,13 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (local_iter == 0){ - ecurrent = energy_force(0); - calc_gradient(); - neval++; - } - calc_search_direction(); + if (local_iter == 0) + ecurrent = energy_force(0); if (use_line_search) { // here we need to do line search - + calc_search_direction(); der_e_cur = 0.0; for (int i = 0; i < 3 * nlocal; i++) { der_e_cur += g_cur[i] * p_s[i]; @@ -235,8 +240,22 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) else{ // here we don't do line search + // but use cutoff rotation angle + // if gneb calc., nreplica > 1 + // then calculate gradients and advance spins + // of intermediate replicas only + if (nreplica > 1) { + if(ireplica != 0 && ireplica != nreplica-1) + calc_gradient(); + calc_search_direction(); advance_spins(); + } else{ + calc_gradient(); + calc_search_direction(); + advance_spins(); + } + neval++; eprevious = ecurrent; ecurrent = energy_force(0); neval++; @@ -265,7 +284,7 @@ int MinSpinOSO_LBFGS_LS::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fmdotfm = fmnorm_sqr(); + fmdotfm = fmnorm2(); if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -340,7 +359,9 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() double *alpha; double factor; + double scaling = 1.0; + // for multiple replica do not move end points if (nreplica > 1) { if (ireplica == 0 || ireplica == nreplica - 1) { factor = 0.0; @@ -354,9 +375,14 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() alpha = (double *) calloc(num_mem, sizeof(double)); if (local_iter == 0){ // steepest descent direction + + //if no line search then calculate maximum rotation + if (use_line_search == 0) + scaling = maximum_rotation(g_cur); + for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i]; - g_old[i] = g_cur[i]; + p_s[i] = -g_cur[i] * factor * scaling;; + g_old[i] = g_cur[i] * factor; for (int k = 0; k < num_mem; k++){ ds[k][i] = 0.0; dy[k][i] = 0.0; @@ -478,9 +504,11 @@ void MinSpinOSO_LBFGS_LS::calc_search_direction() p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); } } + if (use_line_search == 0) + scaling = maximum_rotation(p_s); for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = - factor * p_s[i]; - g_old[i] = g_cur[i]; + p_s[i] = - factor * p_s[i] * scaling; + g_old[i] = g_cur[i] * factor; } } @@ -516,32 +544,21 @@ void MinSpinOSO_LBFGS_LS::advance_spins() } /* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 + compute and return ||mag. torque||_2^2 / N ------------------------------------------------------------------------- */ -double MinSpinOSO_LBFGS_LS::fmnorm_sqr() -{ +double MinSpinOSO_LBFGS_LS::fmnorm2() { + double norm2, norm2_global; int nlocal = atom->nlocal; - double tx,ty,tz; - double **sp = atom->sp; - double **fm = atom->fm; + int ntotal = 0; - // calc. magnetic torques norm - - double local_norm2_sqr = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - local_norm2_sqr += g_cur[i]*g_cur[i]; - } - - // no extra atom calc. for spins - - if (nextra_atom) - error->all(FLERR,"extra atom option not available yet"); - - double norm2_sqr = 0.0; - MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); - - return norm2_sqr; + norm2 = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm2 += g_cur[i] * g_cur[i]; + MPI_Allreduce(&norm2, &norm2_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&nlocal, &ntotal, 1, MPI_INT, MPI_SUM, world); + double ans = norm2_global / (double) ntotal; + MPI_Bcast(&ans, 1, MPI_DOUBLE, 0, world); + return ans; } /* ---------------------------------------------------------------------- @@ -738,3 +755,31 @@ int MinSpinOSO_LBFGS_LS::awc(double der_phi_0, double phi_0, double der_phi_j, d else return 0; } + +double MinSpinOSO_LBFGS_LS::maximum_rotation(double *p) +{ + double norm2,norm2_global,scaling,alpha; + int nlocal = atom->nlocal; + int ntotal = 0; + + norm2 = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; + + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); + if (update->multireplica == 1) { + norm2 = norm2_global; + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); + if (update->multireplica == 1) { + nlocal = ntotal; + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); + } + + scaling = (maxepsrot * sqrt((double) ntotal / norm2_global)); + + if (scaling < 1.0) alpha = scaling; + else alpha = 1.0; + + return alpha; +} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.h b/src/SPIN/min_spin_oso_lbfgs_ls.h index 876e34f9c9..a253808923 100644 --- a/src/SPIN/min_spin_oso_lbfgs_ls.h +++ b/src/SPIN/min_spin_oso_lbfgs_ls.h @@ -35,10 +35,10 @@ public: void reset_vectors(); int iterate(int); void advance_spins(); - double fmnorm_sqr(); + double fmnorm2(); void calc_gradient(); void calc_search_direction(); - + double maximum_rotation(double *); private: int ireplica,nreplica; // for neb @@ -62,7 +62,7 @@ private: double der_e_pr; // previous derivative along search dir. int use_line_search; // use line search or not. - + double maxepsrot; void vm3(const double *, const double *, double *); void rodrigues_rotation(const double *, double *); From ad713d39a41107601c7337ac281627057c2c451c Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 11:58:39 +0000 Subject: [PATCH 047/557] rename min_spin_oso_lbfgs_ls -> min_spin_oso_lbfgs --- src/SPIN/min_spin_oso_lbfgs.cpp | 365 +++++++++----- src/SPIN/min_spin_oso_lbfgs.h | 32 +- src/SPIN/min_spin_oso_lbfgs_ls.cpp | 785 ----------------------------- src/SPIN/min_spin_oso_lbfgs_ls.h | 79 --- 4 files changed, 241 insertions(+), 1020 deletions(-) delete mode 100644 src/SPIN/min_spin_oso_lbfgs_ls.cpp delete mode 100644 src/SPIN/min_spin_oso_lbfgs_ls.h diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index fd83e7b460..7f716da63d 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -63,16 +63,18 @@ static const char cite_minstyle_spin_oso_lbfgs[] = /* ---------------------------------------------------------------------- */ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL) + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL), sp_copy(NULL) { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); nlocal_max = 0; - + // nreplica = number of partitions // ireplica = which world I am in universe nreplica = universe->nworlds; ireplica = universe->iworld; + use_line_search = 1; + maxepsrot = MY_2PI / (100.0); } @@ -86,21 +88,21 @@ MinSpinOSO_LBFGS::~MinSpinOSO_LBFGS() memory->destroy(ds); memory->destroy(dy); memory->destroy(rho); + if (use_line_search) + memory->destroy(sp_copy); } /* ---------------------------------------------------------------------- */ void MinSpinOSO_LBFGS::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; num_mem = 3; local_iter = 0; - maxepsrot = MY_2PI / (100.0); + der_e_cur = 0.0; + der_e_pr = 0.0; Min::init(); - dts = dt = update->dt; last_negative = update->ntimestep; // allocate tables @@ -112,6 +114,8 @@ void MinSpinOSO_LBFGS::init() memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs:sp_copy"); } @@ -135,14 +139,17 @@ void MinSpinOSO_LBFGS::setup_style() int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) { - if (strcmp(arg[0],"alpha_damp") == 0) { + + if (strcmp(arg[0],"line_search") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - alpha_damp = force->numeric(FLERR,arg[1]); + use_line_search = force->numeric(FLERR,arg[1]); return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + double discrete_factor; discrete_factor = force->numeric(FLERR,arg[1]); + maxepsrot = MY_2PI / discrete_factor; return 2; } return 0; @@ -178,6 +185,8 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) bigint ntimestep; double fmdotfm; int flag, flagall; + double **sp = atom->sp; + double der_e_cur_tmp = 0.0; if (nlocal_max < nlocal) { nlocal_max = nlocal; @@ -188,10 +197,12 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs:sp_copy"); } for (int iter = 0; iter < maxiter; iter++) { - + if (timer->check_timeout(niter)) return TIMEOUT; @@ -200,29 +211,53 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (local_iter == 0) energy_force(0); - // to be checked - // if gneb calc., nreplica > 1 - // then calculate gradients of intermediate replicas - if (nreplica > 1) { + if (local_iter == 0) + ecurrent = energy_force(0); + + if (use_line_search) { + + // here we need to do line search + calc_search_direction(); + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp_copy[i][j] = sp[i][j]; + } + eprevious = ecurrent; + der_e_pr = der_e_cur; + calc_and_make_step(0.0, 1.0, 0); + } + else{ + + // here we don't do line search + // but use cutoff rotation angle + // if gneb calc., nreplica > 1 + // then calculate gradients and advance spins + // of intermediate replicas only + + if (nreplica > 1) { if(ireplica != 0 && ireplica != nreplica-1) - calc_gradient(1.0); - } else calc_gradient(1.0); - calc_search_direction(); - - // to be checked - // if gneb calc., nreplica > 1 - // then advance spins only if intermediate replica - // otherwise (simple minimization), advance spins - - if (nreplica > 1) { - if(ireplica != 0 && ireplica != nreplica-1) - advance_spins(); - } else advance_spins(); - eprevious = ecurrent; - ecurrent = energy_force(0); - neval++; + calc_gradient(); + calc_search_direction(); + advance_spins(); + } else{ + calc_gradient(); + calc_search_direction(); + advance_spins(); + } + neval++; + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + } //// energy tolerance criterion //// only check after DELAYSTEP elapsed since velocties reset to 0 @@ -247,7 +282,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fmdotfm = fmnorm_sqr(); + fmdotfm = fmnorm2(); if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -270,56 +305,11 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) return MAXITER; } -/* ---------------------------------------------------------------------- - evaluate max timestep ----------------------------------------------------------------------- */ - -double MinSpinOSO_LBFGS::evaluate_dt() -{ - double dtmax; - double fmsq; - double fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double **fm = atom->fm; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - if (fmaxsqall == 0.0) - error->all(FLERR,"Incorrect fmaxsqall calculation"); - - // define max timestep by dividing by the - // inverse of max frequency by discrete_factor - // std::cout << fmaxsqall << "\n"; - dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); - - return dtmax; -} - /* ---------------------------------------------------------------------- calculate gradients ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::calc_gradient(double dts) +void MinSpinOSO_LBFGS::calc_gradient() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -330,17 +320,11 @@ void MinSpinOSO_LBFGS::calc_gradient(double dts) for (int i = 0; i < nlocal; i++) { - // calc. damping torque - - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - // calculate gradients - g_cur[3 * i + 0] = -tdampz * dts; - g_cur[3 * i + 1] = tdampy * dts; - g_cur[3 * i + 2] = -tdampx * dts; + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); } } @@ -373,8 +357,9 @@ void MinSpinOSO_LBFGS::calc_search_direction() double *alpha; double factor; - double scaling; + double scaling = 1.0; + // for multiple replica do not move end points if (nreplica > 1) { if (ireplica == 0 || ireplica == nreplica - 1) { factor = 0.0; @@ -388,14 +373,19 @@ void MinSpinOSO_LBFGS::calc_search_direction() alpha = (double *) calloc(num_mem, sizeof(double)); if (local_iter == 0){ // steepest descent direction - - scaling = maximum_rotation(g_cur); - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = - g_cur[i] * factor * scaling; - g_old[i] = g_cur[i]; - ds[m_index][i] = 0.0; - dy[m_index][i] = 0.0; + //if no line search then calculate maximum rotation + if (use_line_search == 0) + scaling = maximum_rotation(g_cur); + + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i] * factor * scaling;; + g_old[i] = g_cur[i] * factor; + for (int k = 0; k < num_mem; k++){ + ds[k][i] = 0.0; + dy[k][i] = 0.0; + rho[k] = 0.0; + } } } else { dyds = 0.0; @@ -418,7 +408,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() if (rho[m_index] < 0.0){ local_iter = 0; for (int k = 0; k < num_mem; k++){ - for (int i = 0; i < nlocal; i ++){ + for (int i = 0; i < nlocal; i ++){ ds[k][i] = 0.0; dy[k][i] = 0.0; } @@ -444,7 +434,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() for (int i = 0; i < 3 * nlocal; i++) { sq += ds[c_ind][i] * q[i]; } - MPI_Allreduce(&sq, &sq_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { sq_global *= factor; sq = sq_global; @@ -467,7 +457,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() for (int i = 0; i < 3 * nlocal; i++) { yy += dy[m_index][i] * dy[m_index][i]; } - MPI_Allreduce(&yy, &yy_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { yy_global *= factor; yy = yy_global; @@ -500,7 +490,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() yr += dy[c_ind][i] * p_s[i]; } - MPI_Allreduce(&yr, &yr_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { yr_global *= factor; yr = yr_global; @@ -512,10 +502,11 @@ void MinSpinOSO_LBFGS::calc_search_direction() p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); } } - scaling = maximum_rotation(p_s); + if (use_line_search == 0) + scaling = maximum_rotation(p_s); for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = - factor * p_s[i] * scaling; - g_old[i] = g_cur[i]; + g_old[i] = g_cur[i] * factor; } } @@ -551,36 +542,21 @@ void MinSpinOSO_LBFGS::advance_spins() } /* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 + compute and return ||mag. torque||_2^2 / N ------------------------------------------------------------------------- */ -double MinSpinOSO_LBFGS::fmnorm_sqr() -{ +double MinSpinOSO_LBFGS::fmnorm2() { + double norm2, norm2_global; int nlocal = atom->nlocal; - double tx,ty,tz; - double **sp = atom->sp; - double **fm = atom->fm; + int ntotal = 0; - // calc. magnetic torques - - double local_norm2_sqr = 0.0; - for (int i = 0; i < nlocal; i++) { - tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - local_norm2_sqr += tx*tx + ty*ty + tz*tz; - } - - // no extra atom calc. for spins - - if (nextra_atom) - error->all(FLERR,"extra atom option not available yet"); - - double norm2_sqr = 0.0; - MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); - - return norm2_sqr; + norm2 = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm2 += g_cur[i] * g_cur[i]; + MPI_Allreduce(&norm2, &norm2_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&nlocal, &ntotal, 1, MPI_INT, MPI_SUM, world); + double ans = norm2_global / (double) ntotal; + MPI_Bcast(&ans, 1, MPI_DOUBLE, 0, world); + return ans; } /* ---------------------------------------------------------------------- @@ -659,38 +635,149 @@ void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ out[i] *= 0.0; - for(int j = 0; j < 3; j++){ - out[i] += *(m + 3 * j + i) * v[j]; - } + for(int j = 0; j < 3; j++) + out[i] += *(m + 3 * j + i) * v[j]; } } + +void MinSpinOSO_LBFGS::make_step(double c, double *energy_and_der) +{ + double p_scaled[3]; + int nlocal = atom->nlocal; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + double **sp = atom->sp; + double der_e_cur_tmp = 0.0;; + + for (int i = 0; i < nlocal; i++) { + + // scale the search direction + + for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; + + // calculate rotation matrix + + rodrigues_rotation(p_scaled, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } + + ecurrent = energy_force(0); + calc_gradient(); + neval++; + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp, 1, MPI_DOUBLE, MPI_SUM, world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + energy_and_der[0] = ecurrent; + energy_and_der[1] = der_e_cur; +} + +/* ---------------------------------------------------------------------- + Calculate step length which satisfies approximate Wolfe conditions + using the cubic interpolation +------------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS::calc_and_make_step(double a, double b, int index) +{ + double e_and_d[2] = {0.0,0.0}; + double alpha,c1,c2,c3; + double **sp = atom->sp; + int nlocal = atom->nlocal; + + make_step(b,e_and_d); + ecurrent = e_and_d[0]; + der_e_cur = e_and_d[1]; + index++; + + if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 5){ + MPI_Bcast(&b,1,MPI_DOUBLE,0,world); + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } + return 1; + } + else{ + double r,f0,f1,df0,df1; + r = b - a; + f0 = eprevious; + f1 = ecurrent; + df0 = der_e_pr; + df1 = der_e_cur; + + c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); + c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); + c3 = df0; + + // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 + // has minimum at alpha below. We do not check boundaries. + + alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); + + if (alpha < 0.0) alpha = r/2.0; + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; + } + calc_and_make_step(0.0, alpha, index); + } + + return 0; +} + +/* ---------------------------------------------------------------------- + Approximate Wolfe conditions: + William W. Hager and Hongchao Zhang + SIAM J. optim., 16(1), 170-192. (23 pages) +------------------------------------------------------------------------- */ + +int MinSpinOSO_LBFGS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ + + double eps = 1.0e-6; + double delta = 0.1; + double sigma = 0.9; + + if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + return 1; + else + return 0; +} + double MinSpinOSO_LBFGS::maximum_rotation(double *p) { - double norm, norm_global, scaling, alpha; + double norm2,norm2_global,scaling,alpha; int nlocal = atom->nlocal; int ntotal = 0; - norm = 0.0; - for (int i = 0; i < 3 * nlocal; i++) norm += p[i] * p[i]; + norm2 = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; - MPI_Allreduce(&norm,&norm_global,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); if (update->multireplica == 1) { - norm = norm_global; - MPI_Allreduce(&norm,&norm_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + norm2 = norm2_global; + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); if (update->multireplica == 1) { nlocal = ntotal; MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); } - scaling = (maxepsrot * sqrt((double) ntotal / norm_global)); + scaling = (maxepsrot * sqrt((double) ntotal / norm2_global)); if (scaling < 1.0) alpha = scaling; else alpha = 1.0; return alpha; -} - +} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index c0f8dc484d..91c900f244 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -24,7 +24,7 @@ MinimizeStyle(spin/oso_lbfgs, MinSpinOSO_LBFGS) namespace LAMMPS_NS { -class MinSpinOSO_LBFGS : public Min { +class MinSpinOSO_LBFGS: public Min { public: MinSpinOSO_LBFGS(class LAMMPS *); @@ -34,26 +34,15 @@ public: int modify_param(int, char **); void reset_vectors(); int iterate(int); - double evaluate_dt(); void advance_spins(); - double fmnorm_sqr(); - void calc_gradient(double); + double fmnorm2(); + void calc_gradient(); void calc_search_direction(); double maximum_rotation(double *); private: - - - // test - int ireplica,nreplica; - - // global and spin timesteps + int ireplica,nreplica; // for neb int nlocal_max; // max value of nlocal (for size of lists) - double dt; - double dts; - - double alpha_damp; // damping for spin minimization - double discrete_factor; // factor for spin timestep evaluation double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector @@ -64,13 +53,22 @@ private: double **ds; // change in rotation matrix between two iterations, da double **dy; // change in gradients between two iterations, dg double *rho; // estimation of curvature - int num_mem; // number of stored steps - int local_iter; // number of times we call search_direction + double **sp_copy; // copy of the spins + int num_mem; // number of stored steps + int local_iter; // for neb + + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + + int use_line_search; // use line search or not. double maxepsrot; void vm3(const double *, const double *, double *); void rodrigues_rotation(const double *, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + void make_step(double, double *); bigint last_negative; }; diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.cpp b/src/SPIN/min_spin_oso_lbfgs_ls.cpp deleted file mode 100644 index ddacd3e207..0000000000 --- a/src/SPIN/min_spin_oso_lbfgs_ls.cpp +++ /dev/null @@ -1,785 +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 authors: Aleksei Ivanov (University of Iceland) - Julien Tranchida (SNL) - - Please cite the related publication: - Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust - Algorithm for the Minimisation of the Energy of Spin Systems. arXiv - preprint arXiv:1904.02669. -------------------------------------------------------------------------- */ - -#include -#include -#include -#include -#include "min_spin_oso_lbfgs_ls.h" -#include "universe.h" -#include "atom.h" -#include "citeme.h" -#include "force.h" -#include "update.h" -#include "output.h" -#include "timer.h" -#include "error.h" -#include "memory.h" -#include "modify.h" -#include "math_special.h" -#include "math_const.h" -#include "universe.h" -#include - - -using namespace LAMMPS_NS; -using namespace MathConst; - -static const char cite_minstyle_spin_oso_lbfgs_ls[] = - "min_style spin/oso_lbfgs_ls command:\n\n" - "@article{ivanov2019fast,\n" - "title={Fast and Robust Algorithm for the Minimisation of the Energy of " - "Spin Systems},\n" - "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" - "journal={arXiv preprint arXiv:1904.02669},\n" - "year={2019}\n" - "}\n\n"; - -// EPS_ENERGY = minimum normalization for energy tolerance - -#define EPS_ENERGY 1.0e-8 - -#define DELAYSTEP 5 - - -/* ---------------------------------------------------------------------- */ - -MinSpinOSO_LBFGS_LS::MinSpinOSO_LBFGS_LS(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL), sp_copy(NULL) -{ - if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs_ls); - nlocal_max = 0; - - // nreplica = number of partitions - // ireplica = which world I am in universe - - nreplica = universe->nworlds; - ireplica = universe->iworld; - use_line_search = 1; - maxepsrot = MY_2PI / (100.0); - -} - -/* ---------------------------------------------------------------------- */ - -MinSpinOSO_LBFGS_LS::~MinSpinOSO_LBFGS_LS() -{ - memory->destroy(g_old); - memory->destroy(g_cur); - memory->destroy(p_s); - memory->destroy(ds); - memory->destroy(dy); - memory->destroy(rho); - if (use_line_search) - memory->destroy(sp_copy); -} - -/* ---------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::init() -{ - num_mem = 3; - local_iter = 0; - der_e_cur = 0.0; - der_e_pr = 0.0; - - Min::init(); - - last_negative = update->ntimestep; - - // allocate tables - - nlocal_max = atom->nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs_ls:p_s"); - memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); - memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); - memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); - if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); - -} - -/* ---------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::setup_style() -{ - double **v = atom->v; - int nlocal = atom->nlocal; - - // check if the atom/spin style is defined - - if (!atom->sp_flag) - error->all(FLERR,"min/spin_oso_lbfgs_ls requires atom/spin style"); - - for (int i = 0; i < nlocal; i++) - v[i][0] = v[i][1] = v[i][2] = 0.0; -} - -/* ---------------------------------------------------------------------- */ - -int MinSpinOSO_LBFGS_LS::modify_param(int narg, char **arg) -{ - - if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - use_line_search = force->numeric(FLERR,arg[1]); - return 2; - } - if (strcmp(arg[0],"discrete_factor") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - double discrete_factor; - discrete_factor = force->numeric(FLERR,arg[1]); - maxepsrot = MY_2PI / discrete_factor; - return 2; - } - return 0; -} - -/* ---------------------------------------------------------------------- - set current vector lengths and pointers - called after atoms have migrated -------------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::reset_vectors() -{ - // atomic dof - - // size sp is 4N vector - nvec = 4 * atom->nlocal; - if (nvec) spvec = atom->sp[0]; - - nvec = 3 * atom->nlocal; - if (nvec) fmvec = atom->fm[0]; - - if (nvec) xvec = atom->x[0]; - if (nvec) fvec = atom->f[0]; -} - -/* ---------------------------------------------------------------------- - minimization via damped spin dynamics -------------------------------------------------------------------------- */ - -int MinSpinOSO_LBFGS_LS::iterate(int maxiter) -{ - int nlocal = atom->nlocal; - bigint ntimestep; - double fmdotfm; - int flag, flagall; - double **sp = atom->sp; - double der_e_cur_tmp = 0.0; - - if (nlocal_max < nlocal) { - nlocal_max = nlocal; - local_iter = 0; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs_ls:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs_ls:p_s"); - memory->grow(rho,num_mem,"min/spin/oso/lbfgs_ls:rho"); - memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:ds"); - memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs_ls:dy"); - if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs_ls:sp_copy"); - } - - for (int iter = 0; iter < maxiter; iter++) { - - if (timer->check_timeout(niter)) - return TIMEOUT; - - ntimestep = ++update->ntimestep; - niter++; - - // optimize timestep accross processes / replicas - // need a force calculation for timestep optimization - - if (local_iter == 0) - ecurrent = energy_force(0); - - if (use_line_search) { - - // here we need to do line search - calc_search_direction(); - der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - der_e_cur += g_cur[i] * p_s[i]; - } - MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); - der_e_cur = der_e_cur_tmp; - if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++) sp_copy[i][j] = sp[i][j]; - } - eprevious = ecurrent; - der_e_pr = der_e_cur; - calc_and_make_step(0.0, 1.0, 0); - } - else{ - - // here we don't do line search - // but use cutoff rotation angle - // if gneb calc., nreplica > 1 - // then calculate gradients and advance spins - // of intermediate replicas only - - if (nreplica > 1) { - if(ireplica != 0 && ireplica != nreplica-1) - calc_gradient(); - calc_search_direction(); - advance_spins(); - } else{ - calc_gradient(); - calc_search_direction(); - advance_spins(); - } - neval++; - eprevious = ecurrent; - ecurrent = energy_force(0); - neval++; - } - - //// energy tolerance criterion - //// only check after DELAYSTEP elapsed since velocties reset to 0 - //// sync across replicas if running multi-replica minimization - - if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { - if (update->multireplica == 0) { - if (fabs(ecurrent-eprevious) < - update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) - return ETOL; - } else { - if (fabs(ecurrent-eprevious) < - update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) - flag = 0; - else flag = 1; - MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); - if (flagall == 0) return ETOL; - } - } - - // magnetic torque tolerance criterion - // sync across replicas if running multi-replica minimization - - if (update->ftol > 0.0) { - fmdotfm = fmnorm2(); - if (update->multireplica == 0) { - if (fmdotfm < update->ftol*update->ftol) return FTOL; - } else { - if (fmdotfm < update->ftol*update->ftol) flag = 0; - else flag = 1; - MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); - if (flagall == 0) return FTOL; - } - } - - // output for thermo, dump, restart files - - if (output->next == ntimestep) { - timer->stamp(); - output->write(ntimestep); - timer->stamp(Timer::OUTPUT); - } - } - - return MAXITER; -} - -/* ---------------------------------------------------------------------- - calculate gradients ----------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::calc_gradient() -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - - // calculate gradients - - g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - } -} - -/* ---------------------------------------------------------------------- - search direction: - Limited-memory BFGS. - See Jorge Nocedal and Stephen J. Wright 'Numerical - Optimization' Second Edition, 2006 (p. 177) ----------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::calc_search_direction() -{ - int nlocal = atom->nlocal; - - double dyds = 0.0; - double sq = 0.0; - double yy = 0.0; - double yr = 0.0; - double beta = 0.0; - - double dyds_global = 0.0; - double sq_global = 0.0; - double yy_global = 0.0; - double yr_global = 0.0; - double beta_global = 0.0; - - int m_index = local_iter % num_mem; // memory index - int c_ind = 0; - double *q; - double *alpha; - - double factor; - double scaling = 1.0; - - // for multiple replica do not move end points - if (nreplica > 1) { - if (ireplica == 0 || ireplica == nreplica - 1) { - factor = 0.0; - } - else factor = 1.0; - }else{ - factor = 1.0; - } - - q = (double *) calloc(3*nlocal, sizeof(double)); - alpha = (double *) calloc(num_mem, sizeof(double)); - - if (local_iter == 0){ // steepest descent direction - - //if no line search then calculate maximum rotation - if (use_line_search == 0) - scaling = maximum_rotation(g_cur); - - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i] * factor * scaling;; - g_old[i] = g_cur[i] * factor; - for (int k = 0; k < num_mem; k++){ - ds[k][i] = 0.0; - dy[k][i] = 0.0; - rho[k] = 0.0; - } - } - } else { - dyds = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - ds[m_index][i] = p_s[i]; - dy[m_index][i] = g_cur[i] - g_old[i]; - dyds += ds[m_index][i] * dy[m_index][i]; - } - MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); - - if (update->multireplica == 1) { - dyds_global *= factor; - dyds = dyds_global; - MPI_Allreduce(&dyds, &dyds_global, 1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - if (fabs(dyds_global) > 1.0e-60) rho[m_index] = 1.0 / dyds_global; - else rho[m_index] = 1.0e60; - - if (rho[m_index] < 0.0){ - local_iter = 0; - for (int k = 0; k < num_mem; k++){ - for (int i = 0; i < nlocal; i ++){ - ds[k][i] = 0.0; - dy[k][i] = 0.0; - } - } - return calc_search_direction(); - } - - // set the q vector - - for (int i = 0; i < 3 * nlocal; i++) { - q[i] = g_cur[i]; - } - - // loop over last m indecies - for(int k = num_mem - 1; k > -1; k--) { - // this loop should run from the newest memory to the oldest one. - - c_ind = (k + m_index + 1) % num_mem; - - // dot product between dg and q - - sq = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - sq += ds[c_ind][i] * q[i]; - } - MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { - sq_global *= factor; - sq = sq_global; - MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - // update alpha - - alpha[c_ind] = rho[c_ind] * sq_global; - - // update q - - for (int i = 0; i < 3 * nlocal; i++) { - q[i] -= alpha[c_ind] * dy[c_ind][i]; - } - } - - // dot product between dg with itself - yy = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - yy += dy[m_index][i] * dy[m_index][i]; - } - MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { - yy_global *= factor; - yy = yy_global; - MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - // calculate now search direction - - double devis = rho[m_index] * yy_global; - - if (fabs(devis) > 1.0e-60) { - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = factor * q[i] / devis; - } - }else{ - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = factor * q[i] * 1.0e60; - } - } - - for (int k = 0; k < num_mem; k++){ - // this loop should run from the oldest memory to the newest one. - - if (local_iter < num_mem) c_ind = k; - else c_ind = (k + m_index + 1) % num_mem; - - // dot product between p and da - yr = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - yr += dy[c_ind][i] * p_s[i]; - } - - MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { - yr_global *= factor; - yr = yr_global; - MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - beta = rho[c_ind] * yr_global; - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] += ds[c_ind][i] * (alpha[c_ind] - beta); - } - } - if (use_line_search == 0) - scaling = maximum_rotation(p_s); - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = - factor * p_s[i] * scaling; - g_old[i] = g_cur[i] * factor; - } - } - - local_iter++; - free(q); - free(alpha); - -} - -/* ---------------------------------------------------------------------- - rotation of spins along the search direction ----------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::advance_spins() -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p_s + 3 * i, rot_mat); - - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } -} - -/* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 / N -------------------------------------------------------------------------- */ - -double MinSpinOSO_LBFGS_LS::fmnorm2() { - double norm2, norm2_global; - int nlocal = atom->nlocal; - int ntotal = 0; - - norm2 = 0.0; - for (int i = 0; i < 3 * nlocal; i++) norm2 += g_cur[i] * g_cur[i]; - MPI_Allreduce(&norm2, &norm2_global, 1, MPI_DOUBLE, MPI_SUM, world); - MPI_Allreduce(&nlocal, &ntotal, 1, MPI_INT, MPI_SUM, world); - double ans = norm2_global / (double) ntotal; - MPI_Bcast(&ans, 1, MPI_DOUBLE, 0, world); - return ans; -} - -/* ---------------------------------------------------------------------- - calculate 3x3 matrix exponential using Rodrigues' formula - (R. Murray, Z. Li, and S. Shankar Sastry, - A Mathematical Introduction to - Robotic Manipulation (1994), p. 28 and 30). - - upp_tr - vector x, y, z so that one calculate - U = exp(A) with A= [[0, x, y], - [-x, 0, z], - [-y, -z, 0]] -------------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::rodrigues_rotation(const double *upp_tr, double *out) -{ - double theta,A,B,D,x,y,z; - double s1,s2,s3,a1,a2,a3; - - if (fabs(upp_tr[0]) < 1.0e-40 && - fabs(upp_tr[1]) < 1.0e-40 && - fabs(upp_tr[2]) < 1.0e-40){ - - // if upp_tr is zero, return unity matrix - for(int k = 0; k < 3; k++){ - for(int m = 0; m < 3; m++){ - if (m == k) out[3 * k + m] = 1.0; - else out[3 * k + m] = 0.0; - } - } - return; - } - - theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); - - A = cos(theta); - B = sin(theta); - D = 1 - A; - x = upp_tr[0]/theta; - y = upp_tr[1]/theta; - z = upp_tr[2]/theta; - - // diagonal elements of U - - out[0] = A + z * z * D; - out[4] = A + y * y * D; - out[8] = A + x * x * D; - - // off diagonal of U - - s1 = -y * z *D; - s2 = x * z * D; - s3 = -x * y * D; - - a1 = x * B; - a2 = y * B; - a3 = z * B; - - out[1] = s1 + a1; - out[3] = s1 - a1; - out[2] = s2 + a2; - out[6] = s2 - a2; - out[5] = s3 + a3; - out[7] = s3 - a3; - -} - -/* ---------------------------------------------------------------------- - out = vector^T x m, - m -- 3x3 matrix , v -- 3-d vector -------------------------------------------------------------------------- */ - -void MinSpinOSO_LBFGS_LS::vm3(const double *m, const double *v, double *out) -{ - for(int i = 0; i < 3; i++){ - out[i] *= 0.0; - for(int j = 0; j < 3; j++) - out[i] += *(m + 3 * j + i) * v[j]; - } -} - - -void MinSpinOSO_LBFGS_LS::make_step(double c, double *energy_and_der) -{ - double p_scaled[3]; - int nlocal = atom->nlocal; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - double **sp = atom->sp; - double der_e_cur_tmp = 0.0;; - - for (int i = 0; i < nlocal; i++) { - - // scale the search direction - - for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; - - // calculate rotation matrix - - rodrigues_rotation(p_scaled, rot_mat); - - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } - - ecurrent = energy_force(0); - calc_gradient(); - neval++; - der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - der_e_cur += g_cur[i] * p_s[i]; - } - MPI_Allreduce(&der_e_cur,&der_e_cur_tmp, 1, MPI_DOUBLE, MPI_SUM, world); - der_e_cur = der_e_cur_tmp; - if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - energy_and_der[0] = ecurrent; - energy_and_der[1] = der_e_cur; -} - -/* ---------------------------------------------------------------------- - Calculate step length which satisfies approximate Wolfe conditions - using the cubic interpolation -------------------------------------------------------------------------- */ - -int MinSpinOSO_LBFGS_LS::calc_and_make_step(double a, double b, int index) -{ - double e_and_d[2] = {0.0,0.0}; - double alpha,c1,c2,c3; - double **sp = atom->sp; - int nlocal = atom->nlocal; - - make_step(b,e_and_d); - ecurrent = e_and_d[0]; - der_e_cur = e_and_d[1]; - index++; - - if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 5){ - MPI_Bcast(&b,1,MPI_DOUBLE,0,world); - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = b * p_s[i]; - } - return 1; - } - else{ - double r,f0,f1,df0,df1; - r = b - a; - f0 = eprevious; - f1 = ecurrent; - df0 = der_e_pr; - df1 = der_e_cur; - - c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); - c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); - c3 = df0; - - // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 - // has minimum at alpha below. We do not check boundaries. - - alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); - MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); - - if (alpha < 0.0) alpha = r/2.0; - - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; - } - calc_and_make_step(0.0, alpha, index); - } - - return 0; -} - -/* ---------------------------------------------------------------------- - Approximate Wolfe conditions: - William W. Hager and Hongchao Zhang - SIAM J. optim., 16(1), 170-192. (23 pages) -------------------------------------------------------------------------- */ - -int MinSpinOSO_LBFGS_LS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ - - double eps = 1.0e-6; - double delta = 0.1; - double sigma = 0.9; - - if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) - return 1; - else - return 0; -} - -double MinSpinOSO_LBFGS_LS::maximum_rotation(double *p) -{ - double norm2,norm2_global,scaling,alpha; - int nlocal = atom->nlocal; - int ntotal = 0; - - norm2 = 0.0; - for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; - - MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { - norm2 = norm2_global; - MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); - if (update->multireplica == 1) { - nlocal = ntotal; - MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); - } - - scaling = (maxepsrot * sqrt((double) ntotal / norm2_global)); - - if (scaling < 1.0) alpha = scaling; - else alpha = 1.0; - - return alpha; -} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_lbfgs_ls.h b/src/SPIN/min_spin_oso_lbfgs_ls.h deleted file mode 100644 index a253808923..0000000000 --- a/src/SPIN/min_spin_oso_lbfgs_ls.h +++ /dev/null @@ -1,79 +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 MINIMIZE_CLASS - -MinimizeStyle(spin/oso_lbfgs_ls, MinSpinOSO_LBFGS_LS) - -#else - -#ifndef LMP_MIN_SPIN_OSO_LBFGS_LS_H -#define LMP_MIN_SPIN_OSO_LBFGS_LS_H - -#include "min.h" - -namespace LAMMPS_NS { - -class MinSpinOSO_LBFGS_LS : public Min { - -public: - MinSpinOSO_LBFGS_LS(class LAMMPS *); - virtual ~MinSpinOSO_LBFGS_LS(); - void init(); - void setup_style(); - int modify_param(int, char **); - void reset_vectors(); - int iterate(int); - void advance_spins(); - double fmnorm2(); - void calc_gradient(); - void calc_search_direction(); - double maximum_rotation(double *); -private: - int ireplica,nreplica; // for neb - - int nlocal_max; // max value of nlocal (for size of lists) - - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - - double *g_cur; // current gradient vector - double *g_old; // gradient vector at previous step - double *p_s; // search direction vector - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg - double *rho; // estimation of curvature - double **sp_copy; // copy of the spins - - int num_mem; // number of stored steps - int local_iter; // for neb - - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - - int use_line_search; // use line search or not. - double maxepsrot; - - void vm3(const double *, const double *, double *); - void rodrigues_rotation(const double *, double *); - int calc_and_make_step(double, double, int); - int awc(double, double, double, double); - void make_step(double, double *); - - bigint last_negative; -}; - -} - -#endif -#endif From aa5263f729d6cfb996e7b0033c6737b1a6e5d8c9 Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 13:46:26 +0000 Subject: [PATCH 048/557] restructure a bit --- src/SPIN/min_spin_oso_lbfgs.h | 47 +++++++++++++++-------------------- 1 file changed, 20 insertions(+), 27 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 91c900f244..48d1b47837 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -25,8 +25,7 @@ MinimizeStyle(spin/oso_lbfgs, MinSpinOSO_LBFGS) namespace LAMMPS_NS { class MinSpinOSO_LBFGS: public Min { - -public: + public: MinSpinOSO_LBFGS(class LAMMPS *); virtual ~MinSpinOSO_LBFGS(); void init(); @@ -34,42 +33,36 @@ public: int modify_param(int, char **); void reset_vectors(); int iterate(int); + private: + int ireplica,nreplica; // for neb + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_cur; // current gradient vector + double *g_old; // gradient vector at previous step + double *p_s; // search direction vector + double **sp_copy; // copy of the spins + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + void advance_spins(); double fmnorm2(); void calc_gradient(); void calc_search_direction(); double maximum_rotation(double *); -private: - int ireplica,nreplica; // for neb - - int nlocal_max; // max value of nlocal (for size of lists) - - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - - double *g_cur; // current gradient vector - double *g_old; // gradient vector at previous step - double *p_s; // search direction vector - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg - double *rho; // estimation of curvature - double **sp_copy; // copy of the spins - - int num_mem; // number of stored steps - int local_iter; // for neb - - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - - int use_line_search; // use line search or not. - double maxepsrot; - void vm3(const double *, const double *, double *); void rodrigues_rotation(const double *, double *); int calc_and_make_step(double, double, int); int awc(double, double, double, double); void make_step(double, double *); + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + int use_line_search; // use line search or not. + double maxepsrot; + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double *rho; // estimation of curvature + int num_mem; // number of stored steps bigint last_negative; }; From b31548df2e84ded3b50ebbbd53ae94b2cf912e35 Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 16:00:08 +0000 Subject: [PATCH 049/557] convergence criterion based on maximum toque at atom. Minor changes --- src/SPIN/min_spin_oso_lbfgs.cpp | 62 +++++++++++++++++++++------------ src/SPIN/min_spin_oso_lbfgs.h | 2 +- 2 files changed, 40 insertions(+), 24 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 7f716da63d..8d05ea63d8 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -212,25 +212,25 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (local_iter == 0) - ecurrent = energy_force(0); - if (use_line_search) { // here we need to do line search + if (local_iter == 0) + calc_gradient(); + calc_search_direction(); der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { + for (int i = 0; i < 3 * nlocal; i++) der_e_cur += g_cur[i] * p_s[i]; - } MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); der_e_cur = der_e_cur_tmp; if (update->multireplica == 1) { MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++) sp_copy[i][j] = sp[i][j]; - } + for (int i = 0; i < nlocal; i++) + for (int j = 0; j < 3; j++) + sp_copy[i][j] = sp[i][j]; + eprevious = ecurrent; der_e_pr = der_e_cur; calc_and_make_step(0.0, 1.0, 0); @@ -253,7 +253,6 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) calc_search_direction(); advance_spins(); } - neval++; eprevious = ecurrent; ecurrent = energy_force(0); neval++; @@ -282,7 +281,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fmdotfm = fmnorm2(); + fmdotfm = max_torque(); if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -314,8 +313,7 @@ void MinSpinOSO_LBFGS::calc_gradient() int nlocal = atom->nlocal; double **sp = atom->sp; double **fm = atom->fm; - double tdampx, tdampy, tdampz; - + // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { @@ -542,21 +540,39 @@ void MinSpinOSO_LBFGS::advance_spins() } /* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 / N + compute and return max_i||mag. torque_i||_2 ------------------------------------------------------------------------- */ -double MinSpinOSO_LBFGS::fmnorm2() { - double norm2, norm2_global; +double MinSpinOSO_LBFGS::max_torque() +{ + double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; int nlocal = atom->nlocal; - int ntotal = 0; - norm2 = 0.0; - for (int i = 0; i < 3 * nlocal; i++) norm2 += g_cur[i] * g_cur[i]; - MPI_Allreduce(&norm2, &norm2_global, 1, MPI_DOUBLE, MPI_SUM, world); - MPI_Allreduce(&nlocal, &ntotal, 1, MPI_INT, MPI_SUM, world); - double ans = norm2_global / (double) ntotal; - MPI_Bcast(&ans, 1, MPI_DOUBLE, 0, world); - return ans; + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = 0.0; + for (int j = 0; j < 3; j++) + fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + return sqrt(fmaxsqall); } /* ---------------------------------------------------------------------- diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 48d1b47837..d74898aa8c 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -45,7 +45,6 @@ class MinSpinOSO_LBFGS: public Min { int nlocal_max; // max value of nlocal (for size of lists) void advance_spins(); - double fmnorm2(); void calc_gradient(); void calc_search_direction(); double maximum_rotation(double *); @@ -54,6 +53,7 @@ class MinSpinOSO_LBFGS: public Min { int calc_and_make_step(double, double, int); int awc(double, double, double, double); void make_step(double, double *); + double max_torque(); double der_e_cur; // current derivative along search dir. double der_e_pr; // previous derivative along search dir. int use_line_search; // use line search or not. From 3b7bb668aecc3f32d32c1eb4061a112e07536e5b Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 19 Jul 2019 16:41:51 +0000 Subject: [PATCH 050/557] conjugate gradients with line search --- src/SPIN/min_spin_oso_cg2.cpp | 665 ++++++++++++++++++++++++++++++++++ src/SPIN/min_spin_oso_cg2.h | 68 ++++ 2 files changed, 733 insertions(+) create mode 100644 src/SPIN/min_spin_oso_cg2.cpp create mode 100644 src/SPIN/min_spin_oso_cg2.h diff --git a/src/SPIN/min_spin_oso_cg2.cpp b/src/SPIN/min_spin_oso_cg2.cpp new file mode 100644 index 0000000000..23873e24f2 --- /dev/null +++ b/src/SPIN/min_spin_oso_cg2.cpp @@ -0,0 +1,665 @@ +/* ---------------------------------------------------------------------- + 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: Aleksei Ivanov (University of Iceland) + Julien Tranchida (SNL) + + Please cite the related publication: + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + preprint arXiv:1904.02669. +------------------------------------------------------------------------- */ + +#include +#include +#include +#include +#include "min_spin_oso_cg2.h" +#include "universe.h" +#include "atom.h" +#include "citeme.h" +#include "force.h" +#include "update.h" +#include "output.h" +#include "timer.h" +#include "error.h" +#include "memory.h" +#include "modify.h" +#include "math_special.h" +#include "math_const.h" +#include "universe.h" +#include + +using namespace LAMMPS_NS; +using namespace MathConst; + +static const char cite_minstyle_spin_oso_cg2[] = + "min_style spin/oso_cg2 command:\n\n" + "@article{ivanov2019fast,\n" + "title={Fast and Robust Algorithm for the Minimisation of the Energy of " + "Spin Systems},\n" + "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" + "journal={arXiv preprint arXiv:1904.02669},\n" + "year={2019}\n" + "}\n\n"; + +// EPS_ENERGY = minimum normalization for energy tolerance + +#define EPS_ENERGY 1.0e-8 + +#define DELAYSTEP 5 + + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_CG2::MinSpinOSO_CG2(LAMMPS *lmp) : + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL) +{ + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg2); + nlocal_max = 0; + + // nreplica = number of partitions + // ireplica = which world I am in universe + + nreplica = universe->nworlds; + ireplica = universe->iworld; + use_line_search = 1; + maxepsrot = MY_2PI / (100.0); + +} + +/* ---------------------------------------------------------------------- */ + +MinSpinOSO_CG2::~MinSpinOSO_CG2() +{ + memory->destroy(g_old); + memory->destroy(g_cur); + memory->destroy(p_s); + if (use_line_search) + memory->destroy(sp_copy); +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::init() +{ + local_iter = 0; + der_e_cur = 0.0; + der_e_pr = 0.0; + + Min::init(); + + last_negative = update->ntimestep; + + // allocate tables + + nlocal_max = atom->nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg2:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg2:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg2:p_s"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg2:sp_copy"); +} + +/* ---------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::setup_style() +{ + double **v = atom->v; + int nlocal = atom->nlocal; + + // check if the atom/spin style is defined + + if (!atom->sp_flag) + error->all(FLERR,"min/spin_oso_cg2 requires atom/spin style"); + + for (int i = 0; i < nlocal; i++) + v[i][0] = v[i][1] = v[i][2] = 0.0; +} + +/* ---------------------------------------------------------------------- */ + +int MinSpinOSO_CG2::modify_param(int narg, char **arg) +{ + + if (strcmp(arg[0],"line_search") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + use_line_search = force->numeric(FLERR,arg[1]); + return 2; + } + if (strcmp(arg[0],"discrete_factor") == 0) { + if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + double discrete_factor; + discrete_factor = force->numeric(FLERR,arg[1]); + maxepsrot = MY_2PI / discrete_factor; + return 2; + } + return 0; +} + +/* ---------------------------------------------------------------------- + set current vector lengths and pointers + called after atoms have migrated +------------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::reset_vectors() +{ + // atomic dof + + // size sp is 4N vector + nvec = 4 * atom->nlocal; + if (nvec) spvec = atom->sp[0]; + + nvec = 3 * atom->nlocal; + if (nvec) fmvec = atom->fm[0]; + + if (nvec) xvec = atom->x[0]; + if (nvec) fvec = atom->f[0]; +} + +/* ---------------------------------------------------------------------- + minimization via damped spin dynamics +------------------------------------------------------------------------- */ + +int MinSpinOSO_CG2::iterate(int maxiter) +{ + int nlocal = atom->nlocal; + bigint ntimestep; + double fmdotfm; + int flag, flagall; + double **sp = atom->sp; + double der_e_cur_tmp = 0.0; + + if (nlocal_max < nlocal) { + nlocal_max = nlocal; + local_iter = 0; + nlocal_max = nlocal; + memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg2:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg2:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg2:p_s"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg2:sp_copy"); + } + + for (int iter = 0; iter < maxiter; iter++) { + + if (timer->check_timeout(niter)) + return TIMEOUT; + + ntimestep = ++update->ntimestep; + niter++; + + // optimize timestep accross processes / replicas + // need a force calculation for timestep optimization + + if (use_line_search) { + + // here we need to do line search + if (local_iter == 0) + calc_gradient(); + + calc_search_direction(); + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) + der_e_cur += g_cur[i] * p_s[i]; + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + for (int i = 0; i < nlocal; i++) + for (int j = 0; j < 3; j++) + sp_copy[i][j] = sp[i][j]; + + eprevious = ecurrent; + der_e_pr = der_e_cur; + calc_and_make_step(0.0, 1.0, 0); + } + else{ + + // here we don't do line search + // but use cutoff rotation angle + // if gneb calc., nreplica > 1 + // then calculate gradients and advance spins + // of intermediate replicas only + + if (nreplica > 1) { + if(ireplica != 0 && ireplica != nreplica-1) + calc_gradient(); + calc_search_direction(); + advance_spins(); + } else{ + calc_gradient(); + calc_search_direction(); + advance_spins(); + } + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + } + + //// energy tolerance criterion + //// only check after DELAYSTEP elapsed since velocties reset to 0 + //// sync across replicas if running multi-replica minimization + + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { + if (update->multireplica == 0) { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + return ETOL; + } else { + if (fabs(ecurrent-eprevious) < + update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) + flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return ETOL; + } + } + + // magnetic torque tolerance criterion + // sync across replicas if running multi-replica minimization + + if (update->ftol > 0.0) { + fmdotfm = max_torque(); + if (update->multireplica == 0) { + if (fmdotfm < update->ftol*update->ftol) return FTOL; + } else { + if (fmdotfm < update->ftol*update->ftol) flag = 0; + else flag = 1; + MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); + if (flagall == 0) return FTOL; + } + } + + // output for thermo, dump, restart files + + if (output->next == ntimestep) { + timer->stamp(); + output->write(ntimestep); + timer->stamp(Timer::OUTPUT); + } + } + + return MAXITER; +} + +/* ---------------------------------------------------------------------- + calculate gradients +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::calc_gradient() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double hbar = force->hplanck/MY_2PI; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + + // calculate gradients + + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * hbar; + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * hbar; + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * hbar; + } +} + + +/* ---------------------------------------------------------------------- + search direction: + The Fletcher-Reeves conj. grad. method + See Jorge Nocedal and Stephen J. Wright 'Numerical + Optimization' Second Edition, 2006 (p. 121) +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::calc_search_direction() +{ + int nlocal = atom->nlocal; + double g2old = 0.0; + double g2 = 0.0; + double beta = 0.0; + + double g2_global = 0.0; + double g2old_global = 0.0; + double scaling = 1.0; + + if (use_line_search == 0) + scaling = maximum_rotation(g_cur); + + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i] * scaling; + g_old[i] = g_cur[i]; + } + } else { // conjugate direction + for (int i = 0; i < 3 * nlocal; i++) { + g2old += g_old[i] * g_old[i]; + g2 += g_cur[i] * g_cur[i]; + } + + // now we need to collect/broadcast beta on this replica + // different replica can have different beta for now. + // need to check what is beta for GNEB + + MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); + + // Sum over all replicas. Good for GNEB. + if (update->multireplica == 1) { + g2 = g2_global; + g2old = g2old_global; + MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + if (fabs(g2_global) < 1.0e-60) beta = 0.0; + else beta = g2_global / g2old_global; + // calculate conjugate direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = (beta * p_s[i] - g_cur[i])*scaling; + g_old[i] = g_cur[i]; + } + } + + local_iter++; +} + +/* ---------------------------------------------------------------------- + rotation of spins along the search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::advance_spins() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + rodrigues_rotation(p_s + 3 * i, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } +} + +/* ---------------------------------------------------------------------- + compute and return max_i||mag. torque_i||_2 +------------------------------------------------------------------------- */ + +double MinSpinOSO_CG2::max_torque() +{ + double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = 0.0; + for (int j = 0; j < 3; j++) + fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + return sqrt(fmaxsqall); +} + +/* ---------------------------------------------------------------------- + calculate 3x3 matrix exponential using Rodrigues' formula + (R. Murray, Z. Li, and S. Shankar Sastry, + A Mathematical Introduction to + Robotic Manipulation (1994), p. 28 and 30). + + upp_tr - vector x, y, z so that one calculate + U = exp(A) with A= [[0, x, y], + [-x, 0, z], + [-y, -z, 0]] +------------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::rodrigues_rotation(const double *upp_tr, double *out) +{ + double theta,A,B,D,x,y,z; + double s1,s2,s3,a1,a2,a3; + + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + + // if upp_tr is zero, return unity matrix + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } + } + return; + } + + theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); + + A = cos(theta); + B = sin(theta); + D = 1 - A; + x = upp_tr[0]/theta; + y = upp_tr[1]/theta; + z = upp_tr[2]/theta; + + // diagonal elements of U + + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; + + // off diagonal of U + + s1 = -y * z *D; + s2 = x * z * D; + s3 = -x * y * D; + + a1 = x * B; + a2 = y * B; + a3 = z * B; + + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; + +} + +/* ---------------------------------------------------------------------- + out = vector^T x m, + m -- 3x3 matrix , v -- 3-d vector +------------------------------------------------------------------------- */ + +void MinSpinOSO_CG2::vm3(const double *m, const double *v, double *out) +{ + for(int i = 0; i < 3; i++){ + out[i] *= 0.0; + for(int j = 0; j < 3; j++) + out[i] += *(m + 3 * j + i) * v[j]; + } +} + + +void MinSpinOSO_CG2::make_step(double c, double *energy_and_der) +{ + double p_scaled[3]; + int nlocal = atom->nlocal; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + double **sp = atom->sp; + double der_e_cur_tmp = 0.0;; + + for (int i = 0; i < nlocal; i++) { + + // scale the search direction + + for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; + + // calculate rotation matrix + + rodrigues_rotation(p_scaled, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } + + ecurrent = energy_force(0); + calc_gradient(); + neval++; + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + energy_and_der[0] = ecurrent; + energy_and_der[1] = der_e_cur; +} + +/* ---------------------------------------------------------------------- + Calculate step length which satisfies approximate Wolfe conditions + using the cubic interpolation +------------------------------------------------------------------------- */ + +int MinSpinOSO_CG2::calc_and_make_step(double a, double b, int index) +{ + double e_and_d[2] = {0.0,0.0}; + double alpha,c1,c2,c3; + double **sp = atom->sp; + int nlocal = atom->nlocal; + + make_step(b,e_and_d); + ecurrent = e_and_d[0]; + der_e_cur = e_and_d[1]; + index++; + + if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 10){ + MPI_Bcast(&b,1,MPI_DOUBLE,0,world); + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } + return 1; + } + else{ + double r,f0,f1,df0,df1; + r = b - a; + f0 = eprevious; + f1 = ecurrent; + df0 = der_e_pr; + df1 = der_e_cur; + + c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); + c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); + c3 = df0; + + // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 + // has minimum at alpha below. We do not check boundaries. + + alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); + + if (alpha < 0.0) alpha = r/2.0; + + std::cout << alpha << "\n"; + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; + } + calc_and_make_step(0.0, alpha, index); + } + + return 0; +} + +/* ---------------------------------------------------------------------- + Approximate Wolfe conditions: + William W. Hager and Hongchao Zhang + SIAM J. optim., 16(1), 170-192. (23 pages) +------------------------------------------------------------------------- */ + +int MinSpinOSO_CG2::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ + + double eps = 1.0e-6; + double delta = 0.1; + double sigma = 0.9; + + if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + return 1; + else + return 0; +} + +double MinSpinOSO_CG2::maximum_rotation(double *p) +{ + double norm2,norm2_global,scaling,alpha; + int nlocal = atom->nlocal; + int ntotal = 0; + + norm2 = 0.0; + for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; + + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); + if (update->multireplica == 1) { + norm2 = norm2_global; + MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); + if (update->multireplica == 1) { + nlocal = ntotal; + MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); + } + + scaling = (maxepsrot * sqrt((double) ntotal / norm2_global)); + + if (scaling < 1.0) alpha = scaling; + else alpha = 1.0; + + return alpha; +} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_cg2.h b/src/SPIN/min_spin_oso_cg2.h new file mode 100644 index 0000000000..c96e82ca8e --- /dev/null +++ b/src/SPIN/min_spin_oso_cg2.h @@ -0,0 +1,68 @@ +/* -*- 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 MINIMIZE_CLASS + +MinimizeStyle(spin/oso_cg2, MinSpinOSO_CG2) + +#else + +#ifndef LMP_MIN_SPIN_OSO_CG2_H +#define LMP_MIN_SPIN_OSO_CG2_H + +#include "min.h" + +namespace LAMMPS_NS { + +class MinSpinOSO_CG2: public Min { + public: + MinSpinOSO_CG2(class LAMMPS *); + virtual ~MinSpinOSO_CG2(); + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); + private: + int ireplica,nreplica; // for neb + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_cur; // current gradient vector + double *g_old; // gradient vector at previous step + double *p_s; // search direction vector + double **sp_copy; // copy of the spins + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + + void advance_spins(); + void calc_gradient(); + void calc_search_direction(); + double maximum_rotation(double *); + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + void make_step(double, double *); + double max_torque(); + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + int use_line_search; // use line search or not. + double maxepsrot; + + bigint last_negative; +}; + +} + +#endif +#endif From a96e6f220a9dcf26221121a969ee690f06ae2212 Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 13:36:57 -0700 Subject: [PATCH 051/557] updated fix_langevin and made example --- examples/gjf/argon.lmp | 886 ++++++++++++++++++++++++++++++++++ examples/gjf/ff-argon.lmp | 20 + examples/gjf/in.argon | 162 +++++++ examples/gjf/out.argon | 249 ++++++++++ examples/gjf/trajectory.0.dcd | Bin 0 -> 439092 bytes src/fix_langevin.cpp | 272 +++++++++-- src/fix_langevin.h | 7 +- 7 files changed, 1550 insertions(+), 46 deletions(-) create mode 100644 examples/gjf/argon.lmp create mode 100644 examples/gjf/ff-argon.lmp create mode 100644 examples/gjf/in.argon create mode 100644 examples/gjf/out.argon create mode 100644 examples/gjf/trajectory.0.dcd diff --git a/examples/gjf/argon.lmp b/examples/gjf/argon.lmp new file mode 100644 index 0000000000..00214b4c54 --- /dev/null +++ b/examples/gjf/argon.lmp @@ -0,0 +1,886 @@ +LAMMPS description + + 864 atoms + 0 bonds + 0 angles + 0 dihedrals + 0 impropers + + 1 atom types + 0 bond types + 0 angle types + 0 dihedral types + 0 improper types + + + 0.0000000 32.146000 xlo xhi + 0.0000000 32.146000 ylo yhi + 0.0000000 32.146000 zlo zhi + + Atoms + + 1 1 1 0.0000000 0.0000000 2.6790000 2.6790000 + 2 2 1 0.0000000 0.0000000 2.6790000 8.0360000 + 3 3 1 0.0000000 0.0000000 2.6790000 13.3940000 + 4 4 1 0.0000000 0.0000000 2.6790000 18.7520000 + 5 5 1 0.0000000 0.0000000 2.6790000 24.1090000 + 6 6 1 0.0000000 0.0000000 2.6790000 29.4670000 + 7 7 1 0.0000000 0.0000000 8.0360000 2.6790000 + 8 8 1 0.0000000 0.0000000 8.0360000 8.0360000 + 9 9 1 0.0000000 0.0000000 8.0360000 13.3940000 + 10 10 1 0.0000000 0.0000000 8.0360000 18.7520000 + 11 11 1 0.0000000 0.0000000 8.0360000 24.1090000 + 12 12 1 0.0000000 0.0000000 8.0360000 29.4670000 + 13 13 1 0.0000000 0.0000000 13.3940000 2.6790000 + 14 14 1 0.0000000 0.0000000 13.3940000 8.0360000 + 15 15 1 0.0000000 0.0000000 13.3940000 13.3940000 + 16 16 1 0.0000000 0.0000000 13.3940000 18.7520000 + 17 17 1 0.0000000 0.0000000 13.3940000 24.1090000 + 18 18 1 0.0000000 0.0000000 13.3940000 29.4670000 + 19 19 1 0.0000000 0.0000000 18.7520000 2.6790000 + 20 20 1 0.0000000 0.0000000 18.7520000 8.0360000 + 21 21 1 0.0000000 0.0000000 18.7520000 13.3940000 + 22 22 1 0.0000000 0.0000000 18.7520000 18.7520000 + 23 23 1 0.0000000 0.0000000 18.7520000 24.1090000 + 24 24 1 0.0000000 0.0000000 18.7520000 29.4670000 + 25 25 1 0.0000000 0.0000000 24.1090000 2.6790000 + 26 26 1 0.0000000 0.0000000 24.1090000 8.0360000 + 27 27 1 0.0000000 0.0000000 24.1090000 13.3940000 + 28 28 1 0.0000000 0.0000000 24.1090000 18.7520000 + 29 29 1 0.0000000 0.0000000 24.1090000 24.1090000 + 30 30 1 0.0000000 0.0000000 24.1090000 29.4670000 + 31 31 1 0.0000000 0.0000000 29.4670000 2.6790000 + 32 32 1 0.0000000 0.0000000 29.4670000 8.0360000 + 33 33 1 0.0000000 0.0000000 29.4670000 13.3940000 + 34 34 1 0.0000000 0.0000000 29.4670000 18.7520000 + 35 35 1 0.0000000 0.0000000 29.4670000 24.1090000 + 36 36 1 0.0000000 0.0000000 29.4670000 29.4670000 + 37 37 1 0.0000000 5.3580000 2.6790000 2.6790000 + 38 38 1 0.0000000 5.3580000 2.6790000 8.0360000 + 39 39 1 0.0000000 5.3580000 2.6790000 13.3940000 + 40 40 1 0.0000000 5.3580000 2.6790000 18.7520000 + 41 41 1 0.0000000 5.3580000 2.6790000 24.1090000 + 42 42 1 0.0000000 5.3580000 2.6790000 29.4670000 + 43 43 1 0.0000000 5.3580000 8.0360000 2.6790000 + 44 44 1 0.0000000 5.3580000 8.0360000 8.0360000 + 45 45 1 0.0000000 5.3580000 8.0360000 13.3940000 + 46 46 1 0.0000000 5.3580000 8.0360000 18.7520000 + 47 47 1 0.0000000 5.3580000 8.0360000 24.1090000 + 48 48 1 0.0000000 5.3580000 8.0360000 29.4670000 + 49 49 1 0.0000000 5.3580000 13.3940000 2.6790000 + 50 50 1 0.0000000 5.3580000 13.3940000 8.0360000 + 51 51 1 0.0000000 5.3580000 13.3940000 13.3940000 + 52 52 1 0.0000000 5.3580000 13.3940000 18.7520000 + 53 53 1 0.0000000 5.3580000 13.3940000 24.1090000 + 54 54 1 0.0000000 5.3580000 13.3940000 29.4670000 + 55 55 1 0.0000000 5.3580000 18.7520000 2.6790000 + 56 56 1 0.0000000 5.3580000 18.7520000 8.0360000 + 57 57 1 0.0000000 5.3580000 18.7520000 13.3940000 + 58 58 1 0.0000000 5.3580000 18.7520000 18.7520000 + 59 59 1 0.0000000 5.3580000 18.7520000 24.1090000 + 60 60 1 0.0000000 5.3580000 18.7520000 29.4670000 + 61 61 1 0.0000000 5.3580000 24.1090000 2.6790000 + 62 62 1 0.0000000 5.3580000 24.1090000 8.0360000 + 63 63 1 0.0000000 5.3580000 24.1090000 13.3940000 + 64 64 1 0.0000000 5.3580000 24.1090000 18.7520000 + 65 65 1 0.0000000 5.3580000 24.1090000 24.1090000 + 66 66 1 0.0000000 5.3580000 24.1090000 29.4670000 + 67 67 1 0.0000000 5.3580000 29.4670000 2.6790000 + 68 68 1 0.0000000 5.3580000 29.4670000 8.0360000 + 69 69 1 0.0000000 5.3580000 29.4670000 13.3940000 + 70 70 1 0.0000000 5.3580000 29.4670000 18.7520000 + 71 71 1 0.0000000 5.3580000 29.4670000 24.1090000 + 72 72 1 0.0000000 5.3580000 29.4670000 29.4670000 + 73 73 1 0.0000000 10.7150000 2.6790000 2.6790000 + 74 74 1 0.0000000 10.7150000 2.6790000 8.0360000 + 75 75 1 0.0000000 10.7150000 2.6790000 13.3940000 + 76 76 1 0.0000000 10.7150000 2.6790000 18.7520000 + 77 77 1 0.0000000 10.7150000 2.6790000 24.1090000 + 78 78 1 0.0000000 10.7150000 2.6790000 29.4670000 + 79 79 1 0.0000000 10.7150000 8.0360000 2.6790000 + 80 80 1 0.0000000 10.7150000 8.0360000 8.0360000 + 81 81 1 0.0000000 10.7150000 8.0360000 13.3940000 + 82 82 1 0.0000000 10.7150000 8.0360000 18.7520000 + 83 83 1 0.0000000 10.7150000 8.0360000 24.1090000 + 84 84 1 0.0000000 10.7150000 8.0360000 29.4670000 + 85 85 1 0.0000000 10.7150000 13.3940000 2.6790000 + 86 86 1 0.0000000 10.7150000 13.3940000 8.0360000 + 87 87 1 0.0000000 10.7150000 13.3940000 13.3940000 + 88 88 1 0.0000000 10.7150000 13.3940000 18.7520000 + 89 89 1 0.0000000 10.7150000 13.3940000 24.1090000 + 90 90 1 0.0000000 10.7150000 13.3940000 29.4670000 + 91 91 1 0.0000000 10.7150000 18.7520000 2.6790000 + 92 92 1 0.0000000 10.7150000 18.7520000 8.0360000 + 93 93 1 0.0000000 10.7150000 18.7520000 13.3940000 + 94 94 1 0.0000000 10.7150000 18.7520000 18.7520000 + 95 95 1 0.0000000 10.7150000 18.7520000 24.1090000 + 96 96 1 0.0000000 10.7150000 18.7520000 29.4670000 + 97 97 1 0.0000000 10.7150000 24.1090000 2.6790000 + 98 98 1 0.0000000 10.7150000 24.1090000 8.0360000 + 99 99 1 0.0000000 10.7150000 24.1090000 13.3940000 + 100 100 1 0.0000000 10.7150000 24.1090000 18.7520000 + 101 101 1 0.0000000 10.7150000 24.1090000 24.1090000 + 102 102 1 0.0000000 10.7150000 24.1090000 29.4670000 + 103 103 1 0.0000000 10.7150000 29.4670000 2.6790000 + 104 104 1 0.0000000 10.7150000 29.4670000 8.0360000 + 105 105 1 0.0000000 10.7150000 29.4670000 13.3940000 + 106 106 1 0.0000000 10.7150000 29.4670000 18.7520000 + 107 107 1 0.0000000 10.7150000 29.4670000 24.1090000 + 108 108 1 0.0000000 10.7150000 29.4670000 29.4670000 + 109 109 1 0.0000000 16.0730000 2.6790000 2.6790000 + 110 110 1 0.0000000 16.0730000 2.6790000 8.0360000 + 111 111 1 0.0000000 16.0730000 2.6790000 13.3940000 + 112 112 1 0.0000000 16.0730000 2.6790000 18.7520000 + 113 113 1 0.0000000 16.0730000 2.6790000 24.1090000 + 114 114 1 0.0000000 16.0730000 2.6790000 29.4670000 + 115 115 1 0.0000000 16.0730000 8.0360000 2.6790000 + 116 116 1 0.0000000 16.0730000 8.0360000 8.0360000 + 117 117 1 0.0000000 16.0730000 8.0360000 13.3940000 + 118 118 1 0.0000000 16.0730000 8.0360000 18.7520000 + 119 119 1 0.0000000 16.0730000 8.0360000 24.1090000 + 120 120 1 0.0000000 16.0730000 8.0360000 29.4670000 + 121 121 1 0.0000000 16.0730000 13.3940000 2.6790000 + 122 122 1 0.0000000 16.0730000 13.3940000 8.0360000 + 123 123 1 0.0000000 16.0730000 13.3940000 13.3940000 + 124 124 1 0.0000000 16.0730000 13.3940000 18.7520000 + 125 125 1 0.0000000 16.0730000 13.3940000 24.1090000 + 126 126 1 0.0000000 16.0730000 13.3940000 29.4670000 + 127 127 1 0.0000000 16.0730000 18.7520000 2.6790000 + 128 128 1 0.0000000 16.0730000 18.7520000 8.0360000 + 129 129 1 0.0000000 16.0730000 18.7520000 13.3940000 + 130 130 1 0.0000000 16.0730000 18.7520000 18.7520000 + 131 131 1 0.0000000 16.0730000 18.7520000 24.1090000 + 132 132 1 0.0000000 16.0730000 18.7520000 29.4670000 + 133 133 1 0.0000000 16.0730000 24.1090000 2.6790000 + 134 134 1 0.0000000 16.0730000 24.1090000 8.0360000 + 135 135 1 0.0000000 16.0730000 24.1090000 13.3940000 + 136 136 1 0.0000000 16.0730000 24.1090000 18.7520000 + 137 137 1 0.0000000 16.0730000 24.1090000 24.1090000 + 138 138 1 0.0000000 16.0730000 24.1090000 29.4670000 + 139 139 1 0.0000000 16.0730000 29.4670000 2.6790000 + 140 140 1 0.0000000 16.0730000 29.4670000 8.0360000 + 141 141 1 0.0000000 16.0730000 29.4670000 13.3940000 + 142 142 1 0.0000000 16.0730000 29.4670000 18.7520000 + 143 143 1 0.0000000 16.0730000 29.4670000 24.1090000 + 144 144 1 0.0000000 16.0730000 29.4670000 29.4670000 + 145 145 1 0.0000000 21.4310000 2.6790000 2.6790000 + 146 146 1 0.0000000 21.4310000 2.6790000 8.0360000 + 147 147 1 0.0000000 21.4310000 2.6790000 13.3940000 + 148 148 1 0.0000000 21.4310000 2.6790000 18.7520000 + 149 149 1 0.0000000 21.4310000 2.6790000 24.1090000 + 150 150 1 0.0000000 21.4310000 2.6790000 29.4670000 + 151 151 1 0.0000000 21.4310000 8.0360000 2.6790000 + 152 152 1 0.0000000 21.4310000 8.0360000 8.0360000 + 153 153 1 0.0000000 21.4310000 8.0360000 13.3940000 + 154 154 1 0.0000000 21.4310000 8.0360000 18.7520000 + 155 155 1 0.0000000 21.4310000 8.0360000 24.1090000 + 156 156 1 0.0000000 21.4310000 8.0360000 29.4670000 + 157 157 1 0.0000000 21.4310000 13.3940000 2.6790000 + 158 158 1 0.0000000 21.4310000 13.3940000 8.0360000 + 159 159 1 0.0000000 21.4310000 13.3940000 13.3940000 + 160 160 1 0.0000000 21.4310000 13.3940000 18.7520000 + 161 161 1 0.0000000 21.4310000 13.3940000 24.1090000 + 162 162 1 0.0000000 21.4310000 13.3940000 29.4670000 + 163 163 1 0.0000000 21.4310000 18.7520000 2.6790000 + 164 164 1 0.0000000 21.4310000 18.7520000 8.0360000 + 165 165 1 0.0000000 21.4310000 18.7520000 13.3940000 + 166 166 1 0.0000000 21.4310000 18.7520000 18.7520000 + 167 167 1 0.0000000 21.4310000 18.7520000 24.1090000 + 168 168 1 0.0000000 21.4310000 18.7520000 29.4670000 + 169 169 1 0.0000000 21.4310000 24.1090000 2.6790000 + 170 170 1 0.0000000 21.4310000 24.1090000 8.0360000 + 171 171 1 0.0000000 21.4310000 24.1090000 13.3940000 + 172 172 1 0.0000000 21.4310000 24.1090000 18.7520000 + 173 173 1 0.0000000 21.4310000 24.1090000 24.1090000 + 174 174 1 0.0000000 21.4310000 24.1090000 29.4670000 + 175 175 1 0.0000000 21.4310000 29.4670000 2.6790000 + 176 176 1 0.0000000 21.4310000 29.4670000 8.0360000 + 177 177 1 0.0000000 21.4310000 29.4670000 13.3940000 + 178 178 1 0.0000000 21.4310000 29.4670000 18.7520000 + 179 179 1 0.0000000 21.4310000 29.4670000 24.1090000 + 180 180 1 0.0000000 21.4310000 29.4670000 29.4670000 + 181 181 1 0.0000000 26.7880000 2.6790000 2.6790000 + 182 182 1 0.0000000 26.7880000 2.6790000 8.0360000 + 183 183 1 0.0000000 26.7880000 2.6790000 13.3940000 + 184 184 1 0.0000000 26.7880000 2.6790000 18.7520000 + 185 185 1 0.0000000 26.7880000 2.6790000 24.1090000 + 186 186 1 0.0000000 26.7880000 2.6790000 29.4670000 + 187 187 1 0.0000000 26.7880000 8.0360000 2.6790000 + 188 188 1 0.0000000 26.7880000 8.0360000 8.0360000 + 189 189 1 0.0000000 26.7880000 8.0360000 13.3940000 + 190 190 1 0.0000000 26.7880000 8.0360000 18.7520000 + 191 191 1 0.0000000 26.7880000 8.0360000 24.1090000 + 192 192 1 0.0000000 26.7880000 8.0360000 29.4670000 + 193 193 1 0.0000000 26.7880000 13.3940000 2.6790000 + 194 194 1 0.0000000 26.7880000 13.3940000 8.0360000 + 195 195 1 0.0000000 26.7880000 13.3940000 13.3940000 + 196 196 1 0.0000000 26.7880000 13.3940000 18.7520000 + 197 197 1 0.0000000 26.7880000 13.3940000 24.1090000 + 198 198 1 0.0000000 26.7880000 13.3940000 29.4670000 + 199 199 1 0.0000000 26.7880000 18.7520000 2.6790000 + 200 200 1 0.0000000 26.7880000 18.7520000 8.0360000 + 201 201 1 0.0000000 26.7880000 18.7520000 13.3940000 + 202 202 1 0.0000000 26.7880000 18.7520000 18.7520000 + 203 203 1 0.0000000 26.7880000 18.7520000 24.1090000 + 204 204 1 0.0000000 26.7880000 18.7520000 29.4670000 + 205 205 1 0.0000000 26.7880000 24.1090000 2.6790000 + 206 206 1 0.0000000 26.7880000 24.1090000 8.0360000 + 207 207 1 0.0000000 26.7880000 24.1090000 13.3940000 + 208 208 1 0.0000000 26.7880000 24.1090000 18.7520000 + 209 209 1 0.0000000 26.7880000 24.1090000 24.1090000 + 210 210 1 0.0000000 26.7880000 24.1090000 29.4670000 + 211 211 1 0.0000000 26.7880000 29.4670000 2.6790000 + 212 212 1 0.0000000 26.7880000 29.4670000 8.0360000 + 213 213 1 0.0000000 26.7880000 29.4670000 13.3940000 + 214 214 1 0.0000000 26.7880000 29.4670000 18.7520000 + 215 215 1 0.0000000 26.7880000 29.4670000 24.1090000 + 216 216 1 0.0000000 26.7880000 29.4670000 29.4670000 + 217 217 1 0.0000000 2.6790000 5.3580000 2.6790000 + 218 218 1 0.0000000 2.6790000 5.3580000 8.0360000 + 219 219 1 0.0000000 2.6790000 5.3580000 13.3940000 + 220 220 1 0.0000000 2.6790000 5.3580000 18.7520000 + 221 221 1 0.0000000 2.6790000 5.3580000 24.1090000 + 222 222 1 0.0000000 2.6790000 5.3580000 29.4670000 + 223 223 1 0.0000000 2.6790000 10.7150000 2.6790000 + 224 224 1 0.0000000 2.6790000 10.7150000 8.0360000 + 225 225 1 0.0000000 2.6790000 10.7150000 13.3940000 + 226 226 1 0.0000000 2.6790000 10.7150000 18.7520000 + 227 227 1 0.0000000 2.6790000 10.7150000 24.1090000 + 228 228 1 0.0000000 2.6790000 10.7150000 29.4670000 + 229 229 1 0.0000000 2.6790000 16.0730000 2.6790000 + 230 230 1 0.0000000 2.6790000 16.0730000 8.0360000 + 231 231 1 0.0000000 2.6790000 16.0730000 13.3940000 + 232 232 1 0.0000000 2.6790000 16.0730000 18.7520000 + 233 233 1 0.0000000 2.6790000 16.0730000 24.1090000 + 234 234 1 0.0000000 2.6790000 16.0730000 29.4670000 + 235 235 1 0.0000000 2.6790000 21.4310000 2.6790000 + 236 236 1 0.0000000 2.6790000 21.4310000 8.0360000 + 237 237 1 0.0000000 2.6790000 21.4310000 13.3940000 + 238 238 1 0.0000000 2.6790000 21.4310000 18.7520000 + 239 239 1 0.0000000 2.6790000 21.4310000 24.1090000 + 240 240 1 0.0000000 2.6790000 21.4310000 29.4670000 + 241 241 1 0.0000000 2.6790000 26.7880000 2.6790000 + 242 242 1 0.0000000 2.6790000 26.7880000 8.0360000 + 243 243 1 0.0000000 2.6790000 26.7880000 13.3940000 + 244 244 1 0.0000000 2.6790000 26.7880000 18.7520000 + 245 245 1 0.0000000 2.6790000 26.7880000 24.1090000 + 246 246 1 0.0000000 2.6790000 26.7880000 29.4670000 + 247 247 1 0.0000000 2.6790000 32.1460000 2.6790000 + 248 248 1 0.0000000 2.6790000 32.1460000 8.0360000 + 249 249 1 0.0000000 2.6790000 32.1460000 13.3940000 + 250 250 1 0.0000000 2.6790000 32.1460000 18.7520000 + 251 251 1 0.0000000 2.6790000 32.1460000 24.1090000 + 252 252 1 0.0000000 2.6790000 32.1460000 29.4670000 + 253 253 1 0.0000000 8.0360000 5.3580000 2.6790000 + 254 254 1 0.0000000 8.0360000 5.3580000 8.0360000 + 255 255 1 0.0000000 8.0360000 5.3580000 13.3940000 + 256 256 1 0.0000000 8.0360000 5.3580000 18.7520000 + 257 257 1 0.0000000 8.0360000 5.3580000 24.1090000 + 258 258 1 0.0000000 8.0360000 5.3580000 29.4670000 + 259 259 1 0.0000000 8.0360000 10.7150000 2.6790000 + 260 260 1 0.0000000 8.0360000 10.7150000 8.0360000 + 261 261 1 0.0000000 8.0360000 10.7150000 13.3940000 + 262 262 1 0.0000000 8.0360000 10.7150000 18.7520000 + 263 263 1 0.0000000 8.0360000 10.7150000 24.1090000 + 264 264 1 0.0000000 8.0360000 10.7150000 29.4670000 + 265 265 1 0.0000000 8.0360000 16.0730000 2.6790000 + 266 266 1 0.0000000 8.0360000 16.0730000 8.0360000 + 267 267 1 0.0000000 8.0360000 16.0730000 13.3940000 + 268 268 1 0.0000000 8.0360000 16.0730000 18.7520000 + 269 269 1 0.0000000 8.0360000 16.0730000 24.1090000 + 270 270 1 0.0000000 8.0360000 16.0730000 29.4670000 + 271 271 1 0.0000000 8.0360000 21.4310000 2.6790000 + 272 272 1 0.0000000 8.0360000 21.4310000 8.0360000 + 273 273 1 0.0000000 8.0360000 21.4310000 13.3940000 + 274 274 1 0.0000000 8.0360000 21.4310000 18.7520000 + 275 275 1 0.0000000 8.0360000 21.4310000 24.1090000 + 276 276 1 0.0000000 8.0360000 21.4310000 29.4670000 + 277 277 1 0.0000000 8.0360000 26.7880000 2.6790000 + 278 278 1 0.0000000 8.0360000 26.7880000 8.0360000 + 279 279 1 0.0000000 8.0360000 26.7880000 13.3940000 + 280 280 1 0.0000000 8.0360000 26.7880000 18.7520000 + 281 281 1 0.0000000 8.0360000 26.7880000 24.1090000 + 282 282 1 0.0000000 8.0360000 26.7880000 29.4670000 + 283 283 1 0.0000000 8.0360000 32.1460000 2.6790000 + 284 284 1 0.0000000 8.0360000 32.1460000 8.0360000 + 285 285 1 0.0000000 8.0360000 32.1460000 13.3940000 + 286 286 1 0.0000000 8.0360000 32.1460000 18.7520000 + 287 287 1 0.0000000 8.0360000 32.1460000 24.1090000 + 288 288 1 0.0000000 8.0360000 32.1460000 29.4670000 + 289 289 1 0.0000000 13.3940000 5.3580000 2.6790000 + 290 290 1 0.0000000 13.3940000 5.3580000 8.0360000 + 291 291 1 0.0000000 13.3940000 5.3580000 13.3940000 + 292 292 1 0.0000000 13.3940000 5.3580000 18.7520000 + 293 293 1 0.0000000 13.3940000 5.3580000 24.1090000 + 294 294 1 0.0000000 13.3940000 5.3580000 29.4670000 + 295 295 1 0.0000000 13.3940000 10.7150000 2.6790000 + 296 296 1 0.0000000 13.3940000 10.7150000 8.0360000 + 297 297 1 0.0000000 13.3940000 10.7150000 13.3940000 + 298 298 1 0.0000000 13.3940000 10.7150000 18.7520000 + 299 299 1 0.0000000 13.3940000 10.7150000 24.1090000 + 300 300 1 0.0000000 13.3940000 10.7150000 29.4670000 + 301 301 1 0.0000000 13.3940000 16.0730000 2.6790000 + 302 302 1 0.0000000 13.3940000 16.0730000 8.0360000 + 303 303 1 0.0000000 13.3940000 16.0730000 13.3940000 + 304 304 1 0.0000000 13.3940000 16.0730000 18.7520000 + 305 305 1 0.0000000 13.3940000 16.0730000 24.1090000 + 306 306 1 0.0000000 13.3940000 16.0730000 29.4670000 + 307 307 1 0.0000000 13.3940000 21.4310000 2.6790000 + 308 308 1 0.0000000 13.3940000 21.4310000 8.0360000 + 309 309 1 0.0000000 13.3940000 21.4310000 13.3940000 + 310 310 1 0.0000000 13.3940000 21.4310000 18.7520000 + 311 311 1 0.0000000 13.3940000 21.4310000 24.1090000 + 312 312 1 0.0000000 13.3940000 21.4310000 29.4670000 + 313 313 1 0.0000000 13.3940000 26.7880000 2.6790000 + 314 314 1 0.0000000 13.3940000 26.7880000 8.0360000 + 315 315 1 0.0000000 13.3940000 26.7880000 13.3940000 + 316 316 1 0.0000000 13.3940000 26.7880000 18.7520000 + 317 317 1 0.0000000 13.3940000 26.7880000 24.1090000 + 318 318 1 0.0000000 13.3940000 26.7880000 29.4670000 + 319 319 1 0.0000000 13.3940000 32.1460000 2.6790000 + 320 320 1 0.0000000 13.3940000 32.1460000 8.0360000 + 321 321 1 0.0000000 13.3940000 32.1460000 13.3940000 + 322 322 1 0.0000000 13.3940000 32.1460000 18.7520000 + 323 323 1 0.0000000 13.3940000 32.1460000 24.1090000 + 324 324 1 0.0000000 13.3940000 32.1460000 29.4670000 + 325 325 1 0.0000000 18.7520000 5.3580000 2.6790000 + 326 326 1 0.0000000 18.7520000 5.3580000 8.0360000 + 327 327 1 0.0000000 18.7520000 5.3580000 13.3940000 + 328 328 1 0.0000000 18.7520000 5.3580000 18.7520000 + 329 329 1 0.0000000 18.7520000 5.3580000 24.1090000 + 330 330 1 0.0000000 18.7520000 5.3580000 29.4670000 + 331 331 1 0.0000000 18.7520000 10.7150000 2.6790000 + 332 332 1 0.0000000 18.7520000 10.7150000 8.0360000 + 333 333 1 0.0000000 18.7520000 10.7150000 13.3940000 + 334 334 1 0.0000000 18.7520000 10.7150000 18.7520000 + 335 335 1 0.0000000 18.7520000 10.7150000 24.1090000 + 336 336 1 0.0000000 18.7520000 10.7150000 29.4670000 + 337 337 1 0.0000000 18.7520000 16.0730000 2.6790000 + 338 338 1 0.0000000 18.7520000 16.0730000 8.0360000 + 339 339 1 0.0000000 18.7520000 16.0730000 13.3940000 + 340 340 1 0.0000000 18.7520000 16.0730000 18.7520000 + 341 341 1 0.0000000 18.7520000 16.0730000 24.1090000 + 342 342 1 0.0000000 18.7520000 16.0730000 29.4670000 + 343 343 1 0.0000000 18.7520000 21.4310000 2.6790000 + 344 344 1 0.0000000 18.7520000 21.4310000 8.0360000 + 345 345 1 0.0000000 18.7520000 21.4310000 13.3940000 + 346 346 1 0.0000000 18.7520000 21.4310000 18.7520000 + 347 347 1 0.0000000 18.7520000 21.4310000 24.1090000 + 348 348 1 0.0000000 18.7520000 21.4310000 29.4670000 + 349 349 1 0.0000000 18.7520000 26.7880000 2.6790000 + 350 350 1 0.0000000 18.7520000 26.7880000 8.0360000 + 351 351 1 0.0000000 18.7520000 26.7880000 13.3940000 + 352 352 1 0.0000000 18.7520000 26.7880000 18.7520000 + 353 353 1 0.0000000 18.7520000 26.7880000 24.1090000 + 354 354 1 0.0000000 18.7520000 26.7880000 29.4670000 + 355 355 1 0.0000000 18.7520000 32.1460000 2.6790000 + 356 356 1 0.0000000 18.7520000 32.1460000 8.0360000 + 357 357 1 0.0000000 18.7520000 32.1460000 13.3940000 + 358 358 1 0.0000000 18.7520000 32.1460000 18.7520000 + 359 359 1 0.0000000 18.7520000 32.1460000 24.1090000 + 360 360 1 0.0000000 18.7520000 32.1460000 29.4670000 + 361 361 1 0.0000000 24.1090000 5.3580000 2.6790000 + 362 362 1 0.0000000 24.1090000 5.3580000 8.0360000 + 363 363 1 0.0000000 24.1090000 5.3580000 13.3940000 + 364 364 1 0.0000000 24.1090000 5.3580000 18.7520000 + 365 365 1 0.0000000 24.1090000 5.3580000 24.1090000 + 366 366 1 0.0000000 24.1090000 5.3580000 29.4670000 + 367 367 1 0.0000000 24.1090000 10.7150000 2.6790000 + 368 368 1 0.0000000 24.1090000 10.7150000 8.0360000 + 369 369 1 0.0000000 24.1090000 10.7150000 13.3940000 + 370 370 1 0.0000000 24.1090000 10.7150000 18.7520000 + 371 371 1 0.0000000 24.1090000 10.7150000 24.1090000 + 372 372 1 0.0000000 24.1090000 10.7150000 29.4670000 + 373 373 1 0.0000000 24.1090000 16.0730000 2.6790000 + 374 374 1 0.0000000 24.1090000 16.0730000 8.0360000 + 375 375 1 0.0000000 24.1090000 16.0730000 13.3940000 + 376 376 1 0.0000000 24.1090000 16.0730000 18.7520000 + 377 377 1 0.0000000 24.1090000 16.0730000 24.1090000 + 378 378 1 0.0000000 24.1090000 16.0730000 29.4670000 + 379 379 1 0.0000000 24.1090000 21.4310000 2.6790000 + 380 380 1 0.0000000 24.1090000 21.4310000 8.0360000 + 381 381 1 0.0000000 24.1090000 21.4310000 13.3940000 + 382 382 1 0.0000000 24.1090000 21.4310000 18.7520000 + 383 383 1 0.0000000 24.1090000 21.4310000 24.1090000 + 384 384 1 0.0000000 24.1090000 21.4310000 29.4670000 + 385 385 1 0.0000000 24.1090000 26.7880000 2.6790000 + 386 386 1 0.0000000 24.1090000 26.7880000 8.0360000 + 387 387 1 0.0000000 24.1090000 26.7880000 13.3940000 + 388 388 1 0.0000000 24.1090000 26.7880000 18.7520000 + 389 389 1 0.0000000 24.1090000 26.7880000 24.1090000 + 390 390 1 0.0000000 24.1090000 26.7880000 29.4670000 + 391 391 1 0.0000000 24.1090000 32.1460000 2.6790000 + 392 392 1 0.0000000 24.1090000 32.1460000 8.0360000 + 393 393 1 0.0000000 24.1090000 32.1460000 13.3940000 + 394 394 1 0.0000000 24.1090000 32.1460000 18.7520000 + 395 395 1 0.0000000 24.1090000 32.1460000 24.1090000 + 396 396 1 0.0000000 24.1090000 32.1460000 29.4670000 + 397 397 1 0.0000000 29.4670000 5.3580000 2.6790000 + 398 398 1 0.0000000 29.4670000 5.3580000 8.0360000 + 399 399 1 0.0000000 29.4670000 5.3580000 13.3940000 + 400 400 1 0.0000000 29.4670000 5.3580000 18.7520000 + 401 401 1 0.0000000 29.4670000 5.3580000 24.1090000 + 402 402 1 0.0000000 29.4670000 5.3580000 29.4670000 + 403 403 1 0.0000000 29.4670000 10.7150000 2.6790000 + 404 404 1 0.0000000 29.4670000 10.7150000 8.0360000 + 405 405 1 0.0000000 29.4670000 10.7150000 13.3940000 + 406 406 1 0.0000000 29.4670000 10.7150000 18.7520000 + 407 407 1 0.0000000 29.4670000 10.7150000 24.1090000 + 408 408 1 0.0000000 29.4670000 10.7150000 29.4670000 + 409 409 1 0.0000000 29.4670000 16.0730000 2.6790000 + 410 410 1 0.0000000 29.4670000 16.0730000 8.0360000 + 411 411 1 0.0000000 29.4670000 16.0730000 13.3940000 + 412 412 1 0.0000000 29.4670000 16.0730000 18.7520000 + 413 413 1 0.0000000 29.4670000 16.0730000 24.1090000 + 414 414 1 0.0000000 29.4670000 16.0730000 29.4670000 + 415 415 1 0.0000000 29.4670000 21.4310000 2.6790000 + 416 416 1 0.0000000 29.4670000 21.4310000 8.0360000 + 417 417 1 0.0000000 29.4670000 21.4310000 13.3940000 + 418 418 1 0.0000000 29.4670000 21.4310000 18.7520000 + 419 419 1 0.0000000 29.4670000 21.4310000 24.1090000 + 420 420 1 0.0000000 29.4670000 21.4310000 29.4670000 + 421 421 1 0.0000000 29.4670000 26.7880000 2.6790000 + 422 422 1 0.0000000 29.4670000 26.7880000 8.0360000 + 423 423 1 0.0000000 29.4670000 26.7880000 13.3940000 + 424 424 1 0.0000000 29.4670000 26.7880000 18.7520000 + 425 425 1 0.0000000 29.4670000 26.7880000 24.1090000 + 426 426 1 0.0000000 29.4670000 26.7880000 29.4670000 + 427 427 1 0.0000000 29.4670000 32.1460000 2.6790000 + 428 428 1 0.0000000 29.4670000 32.1460000 8.0360000 + 429 429 1 0.0000000 29.4670000 32.1460000 13.3940000 + 430 430 1 0.0000000 29.4670000 32.1460000 18.7520000 + 431 431 1 0.0000000 29.4670000 32.1460000 24.1090000 + 432 432 1 0.0000000 29.4670000 32.1460000 29.4670000 + 433 433 1 0.0000000 2.6790000 2.6790000 5.3580000 + 434 434 1 0.0000000 2.6790000 2.6790000 10.7150000 + 435 435 1 0.0000000 2.6790000 2.6790000 16.0730000 + 436 436 1 0.0000000 2.6790000 2.6790000 21.4310000 + 437 437 1 0.0000000 2.6790000 2.6790000 26.7880000 + 438 438 1 0.0000000 2.6790000 2.6790000 32.1460000 + 439 439 1 0.0000000 2.6790000 8.0360000 5.3580000 + 440 440 1 0.0000000 2.6790000 8.0360000 10.7150000 + 441 441 1 0.0000000 2.6790000 8.0360000 16.0730000 + 442 442 1 0.0000000 2.6790000 8.0360000 21.4310000 + 443 443 1 0.0000000 2.6790000 8.0360000 26.7880000 + 444 444 1 0.0000000 2.6790000 8.0360000 32.1460000 + 445 445 1 0.0000000 2.6790000 13.3940000 5.3580000 + 446 446 1 0.0000000 2.6790000 13.3940000 10.7150000 + 447 447 1 0.0000000 2.6790000 13.3940000 16.0730000 + 448 448 1 0.0000000 2.6790000 13.3940000 21.4310000 + 449 449 1 0.0000000 2.6790000 13.3940000 26.7880000 + 450 450 1 0.0000000 2.6790000 13.3940000 32.1460000 + 451 451 1 0.0000000 2.6790000 18.7520000 5.3580000 + 452 452 1 0.0000000 2.6790000 18.7520000 10.7150000 + 453 453 1 0.0000000 2.6790000 18.7520000 16.0730000 + 454 454 1 0.0000000 2.6790000 18.7520000 21.4310000 + 455 455 1 0.0000000 2.6790000 18.7520000 26.7880000 + 456 456 1 0.0000000 2.6790000 18.7520000 32.1460000 + 457 457 1 0.0000000 2.6790000 24.1090000 5.3580000 + 458 458 1 0.0000000 2.6790000 24.1090000 10.7150000 + 459 459 1 0.0000000 2.6790000 24.1090000 16.0730000 + 460 460 1 0.0000000 2.6790000 24.1090000 21.4310000 + 461 461 1 0.0000000 2.6790000 24.1090000 26.7880000 + 462 462 1 0.0000000 2.6790000 24.1090000 32.1460000 + 463 463 1 0.0000000 2.6790000 29.4670000 5.3580000 + 464 464 1 0.0000000 2.6790000 29.4670000 10.7150000 + 465 465 1 0.0000000 2.6790000 29.4670000 16.0730000 + 466 466 1 0.0000000 2.6790000 29.4670000 21.4310000 + 467 467 1 0.0000000 2.6790000 29.4670000 26.7880000 + 468 468 1 0.0000000 2.6790000 29.4670000 32.1460000 + 469 469 1 0.0000000 8.0360000 2.6790000 5.3580000 + 470 470 1 0.0000000 8.0360000 2.6790000 10.7150000 + 471 471 1 0.0000000 8.0360000 2.6790000 16.0730000 + 472 472 1 0.0000000 8.0360000 2.6790000 21.4310000 + 473 473 1 0.0000000 8.0360000 2.6790000 26.7880000 + 474 474 1 0.0000000 8.0360000 2.6790000 32.1460000 + 475 475 1 0.0000000 8.0360000 8.0360000 5.3580000 + 476 476 1 0.0000000 8.0360000 8.0360000 10.7150000 + 477 477 1 0.0000000 8.0360000 8.0360000 16.0730000 + 478 478 1 0.0000000 8.0360000 8.0360000 21.4310000 + 479 479 1 0.0000000 8.0360000 8.0360000 26.7880000 + 480 480 1 0.0000000 8.0360000 8.0360000 32.1460000 + 481 481 1 0.0000000 8.0360000 13.3940000 5.3580000 + 482 482 1 0.0000000 8.0360000 13.3940000 10.7150000 + 483 483 1 0.0000000 8.0360000 13.3940000 16.0730000 + 484 484 1 0.0000000 8.0360000 13.3940000 21.4310000 + 485 485 1 0.0000000 8.0360000 13.3940000 26.7880000 + 486 486 1 0.0000000 8.0360000 13.3940000 32.1460000 + 487 487 1 0.0000000 8.0360000 18.7520000 5.3580000 + 488 488 1 0.0000000 8.0360000 18.7520000 10.7150000 + 489 489 1 0.0000000 8.0360000 18.7520000 16.0730000 + 490 490 1 0.0000000 8.0360000 18.7520000 21.4310000 + 491 491 1 0.0000000 8.0360000 18.7520000 26.7880000 + 492 492 1 0.0000000 8.0360000 18.7520000 32.1460000 + 493 493 1 0.0000000 8.0360000 24.1090000 5.3580000 + 494 494 1 0.0000000 8.0360000 24.1090000 10.7150000 + 495 495 1 0.0000000 8.0360000 24.1090000 16.0730000 + 496 496 1 0.0000000 8.0360000 24.1090000 21.4310000 + 497 497 1 0.0000000 8.0360000 24.1090000 26.7880000 + 498 498 1 0.0000000 8.0360000 24.1090000 32.1460000 + 499 499 1 0.0000000 8.0360000 29.4670000 5.3580000 + 500 500 1 0.0000000 8.0360000 29.4670000 10.7150000 + 501 501 1 0.0000000 8.0360000 29.4670000 16.0730000 + 502 502 1 0.0000000 8.0360000 29.4670000 21.4310000 + 503 503 1 0.0000000 8.0360000 29.4670000 26.7880000 + 504 504 1 0.0000000 8.0360000 29.4670000 32.1460000 + 505 505 1 0.0000000 13.3940000 2.6790000 5.3580000 + 506 506 1 0.0000000 13.3940000 2.6790000 10.7150000 + 507 507 1 0.0000000 13.3940000 2.6790000 16.0730000 + 508 508 1 0.0000000 13.3940000 2.6790000 21.4310000 + 509 509 1 0.0000000 13.3940000 2.6790000 26.7880000 + 510 510 1 0.0000000 13.3940000 2.6790000 32.1460000 + 511 511 1 0.0000000 13.3940000 8.0360000 5.3580000 + 512 512 1 0.0000000 13.3940000 8.0360000 10.7150000 + 513 513 1 0.0000000 13.3940000 8.0360000 16.0730000 + 514 514 1 0.0000000 13.3940000 8.0360000 21.4310000 + 515 515 1 0.0000000 13.3940000 8.0360000 26.7880000 + 516 516 1 0.0000000 13.3940000 8.0360000 32.1460000 + 517 517 1 0.0000000 13.3940000 13.3940000 5.3580000 + 518 518 1 0.0000000 13.3940000 13.3940000 10.7150000 + 519 519 1 0.0000000 13.3940000 13.3940000 16.0730000 + 520 520 1 0.0000000 13.3940000 13.3940000 21.4310000 + 521 521 1 0.0000000 13.3940000 13.3940000 26.7880000 + 522 522 1 0.0000000 13.3940000 13.3940000 32.1460000 + 523 523 1 0.0000000 13.3940000 18.7520000 5.3580000 + 524 524 1 0.0000000 13.3940000 18.7520000 10.7150000 + 525 525 1 0.0000000 13.3940000 18.7520000 16.0730000 + 526 526 1 0.0000000 13.3940000 18.7520000 21.4310000 + 527 527 1 0.0000000 13.3940000 18.7520000 26.7880000 + 528 528 1 0.0000000 13.3940000 18.7520000 32.1460000 + 529 529 1 0.0000000 13.3940000 24.1090000 5.3580000 + 530 530 1 0.0000000 13.3940000 24.1090000 10.7150000 + 531 531 1 0.0000000 13.3940000 24.1090000 16.0730000 + 532 532 1 0.0000000 13.3940000 24.1090000 21.4310000 + 533 533 1 0.0000000 13.3940000 24.1090000 26.7880000 + 534 534 1 0.0000000 13.3940000 24.1090000 32.1460000 + 535 535 1 0.0000000 13.3940000 29.4670000 5.3580000 + 536 536 1 0.0000000 13.3940000 29.4670000 10.7150000 + 537 537 1 0.0000000 13.3940000 29.4670000 16.0730000 + 538 538 1 0.0000000 13.3940000 29.4670000 21.4310000 + 539 539 1 0.0000000 13.3940000 29.4670000 26.7880000 + 540 540 1 0.0000000 13.3940000 29.4670000 32.1460000 + 541 541 1 0.0000000 18.7520000 2.6790000 5.3580000 + 542 542 1 0.0000000 18.7520000 2.6790000 10.7150000 + 543 543 1 0.0000000 18.7520000 2.6790000 16.0730000 + 544 544 1 0.0000000 18.7520000 2.6790000 21.4310000 + 545 545 1 0.0000000 18.7520000 2.6790000 26.7880000 + 546 546 1 0.0000000 18.7520000 2.6790000 32.1460000 + 547 547 1 0.0000000 18.7520000 8.0360000 5.3580000 + 548 548 1 0.0000000 18.7520000 8.0360000 10.7150000 + 549 549 1 0.0000000 18.7520000 8.0360000 16.0730000 + 550 550 1 0.0000000 18.7520000 8.0360000 21.4310000 + 551 551 1 0.0000000 18.7520000 8.0360000 26.7880000 + 552 552 1 0.0000000 18.7520000 8.0360000 32.1460000 + 553 553 1 0.0000000 18.7520000 13.3940000 5.3580000 + 554 554 1 0.0000000 18.7520000 13.3940000 10.7150000 + 555 555 1 0.0000000 18.7520000 13.3940000 16.0730000 + 556 556 1 0.0000000 18.7520000 13.3940000 21.4310000 + 557 557 1 0.0000000 18.7520000 13.3940000 26.7880000 + 558 558 1 0.0000000 18.7520000 13.3940000 32.1460000 + 559 559 1 0.0000000 18.7520000 18.7520000 5.3580000 + 560 560 1 0.0000000 18.7520000 18.7520000 10.7150000 + 561 561 1 0.0000000 18.7520000 18.7520000 16.0730000 + 562 562 1 0.0000000 18.7520000 18.7520000 21.4310000 + 563 563 1 0.0000000 18.7520000 18.7520000 26.7880000 + 564 564 1 0.0000000 18.7520000 18.7520000 32.1460000 + 565 565 1 0.0000000 18.7520000 24.1090000 5.3580000 + 566 566 1 0.0000000 18.7520000 24.1090000 10.7150000 + 567 567 1 0.0000000 18.7520000 24.1090000 16.0730000 + 568 568 1 0.0000000 18.7520000 24.1090000 21.4310000 + 569 569 1 0.0000000 18.7520000 24.1090000 26.7880000 + 570 570 1 0.0000000 18.7520000 24.1090000 32.1460000 + 571 571 1 0.0000000 18.7520000 29.4670000 5.3580000 + 572 572 1 0.0000000 18.7520000 29.4670000 10.7150000 + 573 573 1 0.0000000 18.7520000 29.4670000 16.0730000 + 574 574 1 0.0000000 18.7520000 29.4670000 21.4310000 + 575 575 1 0.0000000 18.7520000 29.4670000 26.7880000 + 576 576 1 0.0000000 18.7520000 29.4670000 32.1460000 + 577 577 1 0.0000000 24.1090000 2.6790000 5.3580000 + 578 578 1 0.0000000 24.1090000 2.6790000 10.7150000 + 579 579 1 0.0000000 24.1090000 2.6790000 16.0730000 + 580 580 1 0.0000000 24.1090000 2.6790000 21.4310000 + 581 581 1 0.0000000 24.1090000 2.6790000 26.7880000 + 582 582 1 0.0000000 24.1090000 2.6790000 32.1460000 + 583 583 1 0.0000000 24.1090000 8.0360000 5.3580000 + 584 584 1 0.0000000 24.1090000 8.0360000 10.7150000 + 585 585 1 0.0000000 24.1090000 8.0360000 16.0730000 + 586 586 1 0.0000000 24.1090000 8.0360000 21.4310000 + 587 587 1 0.0000000 24.1090000 8.0360000 26.7880000 + 588 588 1 0.0000000 24.1090000 8.0360000 32.1460000 + 589 589 1 0.0000000 24.1090000 13.3940000 5.3580000 + 590 590 1 0.0000000 24.1090000 13.3940000 10.7150000 + 591 591 1 0.0000000 24.1090000 13.3940000 16.0730000 + 592 592 1 0.0000000 24.1090000 13.3940000 21.4310000 + 593 593 1 0.0000000 24.1090000 13.3940000 26.7880000 + 594 594 1 0.0000000 24.1090000 13.3940000 32.1460000 + 595 595 1 0.0000000 24.1090000 18.7520000 5.3580000 + 596 596 1 0.0000000 24.1090000 18.7520000 10.7150000 + 597 597 1 0.0000000 24.1090000 18.7520000 16.0730000 + 598 598 1 0.0000000 24.1090000 18.7520000 21.4310000 + 599 599 1 0.0000000 24.1090000 18.7520000 26.7880000 + 600 600 1 0.0000000 24.1090000 18.7520000 32.1460000 + 601 601 1 0.0000000 24.1090000 24.1090000 5.3580000 + 602 602 1 0.0000000 24.1090000 24.1090000 10.7150000 + 603 603 1 0.0000000 24.1090000 24.1090000 16.0730000 + 604 604 1 0.0000000 24.1090000 24.1090000 21.4310000 + 605 605 1 0.0000000 24.1090000 24.1090000 26.7880000 + 606 606 1 0.0000000 24.1090000 24.1090000 32.1460000 + 607 607 1 0.0000000 24.1090000 29.4670000 5.3580000 + 608 608 1 0.0000000 24.1090000 29.4670000 10.7150000 + 609 609 1 0.0000000 24.1090000 29.4670000 16.0730000 + 610 610 1 0.0000000 24.1090000 29.4670000 21.4310000 + 611 611 1 0.0000000 24.1090000 29.4670000 26.7880000 + 612 612 1 0.0000000 24.1090000 29.4670000 32.1460000 + 613 613 1 0.0000000 29.4670000 2.6790000 5.3580000 + 614 614 1 0.0000000 29.4670000 2.6790000 10.7150000 + 615 615 1 0.0000000 29.4670000 2.6790000 16.0730000 + 616 616 1 0.0000000 29.4670000 2.6790000 21.4310000 + 617 617 1 0.0000000 29.4670000 2.6790000 26.7880000 + 618 618 1 0.0000000 29.4670000 2.6790000 32.1460000 + 619 619 1 0.0000000 29.4670000 8.0360000 5.3580000 + 620 620 1 0.0000000 29.4670000 8.0360000 10.7150000 + 621 621 1 0.0000000 29.4670000 8.0360000 16.0730000 + 622 622 1 0.0000000 29.4670000 8.0360000 21.4310000 + 623 623 1 0.0000000 29.4670000 8.0360000 26.7880000 + 624 624 1 0.0000000 29.4670000 8.0360000 32.1460000 + 625 625 1 0.0000000 29.4670000 13.3940000 5.3580000 + 626 626 1 0.0000000 29.4670000 13.3940000 10.7150000 + 627 627 1 0.0000000 29.4670000 13.3940000 16.0730000 + 628 628 1 0.0000000 29.4670000 13.3940000 21.4310000 + 629 629 1 0.0000000 29.4670000 13.3940000 26.7880000 + 630 630 1 0.0000000 29.4670000 13.3940000 32.1460000 + 631 631 1 0.0000000 29.4670000 18.7520000 5.3580000 + 632 632 1 0.0000000 29.4670000 18.7520000 10.7150000 + 633 633 1 0.0000000 29.4670000 18.7520000 16.0730000 + 634 634 1 0.0000000 29.4670000 18.7520000 21.4310000 + 635 635 1 0.0000000 29.4670000 18.7520000 26.7880000 + 636 636 1 0.0000000 29.4670000 18.7520000 32.1460000 + 637 637 1 0.0000000 29.4670000 24.1090000 5.3580000 + 638 638 1 0.0000000 29.4670000 24.1090000 10.7150000 + 639 639 1 0.0000000 29.4670000 24.1090000 16.0730000 + 640 640 1 0.0000000 29.4670000 24.1090000 21.4310000 + 641 641 1 0.0000000 29.4670000 24.1090000 26.7880000 + 642 642 1 0.0000000 29.4670000 24.1090000 32.1460000 + 643 643 1 0.0000000 29.4670000 29.4670000 5.3580000 + 644 644 1 0.0000000 29.4670000 29.4670000 10.7150000 + 645 645 1 0.0000000 29.4670000 29.4670000 16.0730000 + 646 646 1 0.0000000 29.4670000 29.4670000 21.4310000 + 647 647 1 0.0000000 29.4670000 29.4670000 26.7880000 + 648 648 1 0.0000000 29.4670000 29.4670000 32.1460000 + 649 649 1 0.0000000 0.0000000 5.3580000 5.3580000 + 650 650 1 0.0000000 0.0000000 5.3580000 10.7150000 + 651 651 1 0.0000000 0.0000000 5.3580000 16.0730000 + 652 652 1 0.0000000 0.0000000 5.3580000 21.4310000 + 653 653 1 0.0000000 0.0000000 5.3580000 26.7880000 + 654 654 1 0.0000000 0.0000000 5.3580000 32.1460000 + 655 655 1 0.0000000 0.0000000 10.7150000 5.3580000 + 656 656 1 0.0000000 0.0000000 10.7150000 10.7150000 + 657 657 1 0.0000000 0.0000000 10.7150000 16.0730000 + 658 658 1 0.0000000 0.0000000 10.7150000 21.4310000 + 659 659 1 0.0000000 0.0000000 10.7150000 26.7880000 + 660 660 1 0.0000000 0.0000000 10.7150000 32.1460000 + 661 661 1 0.0000000 0.0000000 16.0730000 5.3580000 + 662 662 1 0.0000000 0.0000000 16.0730000 10.7150000 + 663 663 1 0.0000000 0.0000000 16.0730000 16.0730000 + 664 664 1 0.0000000 0.0000000 16.0730000 21.4310000 + 665 665 1 0.0000000 0.0000000 16.0730000 26.7880000 + 666 666 1 0.0000000 0.0000000 16.0730000 32.1460000 + 667 667 1 0.0000000 0.0000000 21.4310000 5.3580000 + 668 668 1 0.0000000 0.0000000 21.4310000 10.7150000 + 669 669 1 0.0000000 0.0000000 21.4310000 16.0730000 + 670 670 1 0.0000000 0.0000000 21.4310000 21.4310000 + 671 671 1 0.0000000 0.0000000 21.4310000 26.7880000 + 672 672 1 0.0000000 0.0000000 21.4310000 32.1460000 + 673 673 1 0.0000000 0.0000000 26.7880000 5.3580000 + 674 674 1 0.0000000 0.0000000 26.7880000 10.7150000 + 675 675 1 0.0000000 0.0000000 26.7880000 16.0730000 + 676 676 1 0.0000000 0.0000000 26.7880000 21.4310000 + 677 677 1 0.0000000 0.0000000 26.7880000 26.7880000 + 678 678 1 0.0000000 0.0000000 26.7880000 32.1460000 + 679 679 1 0.0000000 0.0000000 32.1460000 5.3580000 + 680 680 1 0.0000000 0.0000000 32.1460000 10.7150000 + 681 681 1 0.0000000 0.0000000 32.1460000 16.0730000 + 682 682 1 0.0000000 0.0000000 32.1460000 21.4310000 + 683 683 1 0.0000000 0.0000000 32.1460000 26.7880000 + 684 684 1 0.0000000 0.0000000 32.1460000 32.1460000 + 685 685 1 0.0000000 5.3580000 5.3580000 5.3580000 + 686 686 1 0.0000000 5.3580000 5.3580000 10.7150000 + 687 687 1 0.0000000 5.3580000 5.3580000 16.0730000 + 688 688 1 0.0000000 5.3580000 5.3580000 21.4310000 + 689 689 1 0.0000000 5.3580000 5.3580000 26.7880000 + 690 690 1 0.0000000 5.3580000 5.3580000 32.1460000 + 691 691 1 0.0000000 5.3580000 10.7150000 5.3580000 + 692 692 1 0.0000000 5.3580000 10.7150000 10.7150000 + 693 693 1 0.0000000 5.3580000 10.7150000 16.0730000 + 694 694 1 0.0000000 5.3580000 10.7150000 21.4310000 + 695 695 1 0.0000000 5.3580000 10.7150000 26.7880000 + 696 696 1 0.0000000 5.3580000 10.7150000 32.1460000 + 697 697 1 0.0000000 5.3580000 16.0730000 5.3580000 + 698 698 1 0.0000000 5.3580000 16.0730000 10.7150000 + 699 699 1 0.0000000 5.3580000 16.0730000 16.0730000 + 700 700 1 0.0000000 5.3580000 16.0730000 21.4310000 + 701 701 1 0.0000000 5.3580000 16.0730000 26.7880000 + 702 702 1 0.0000000 5.3580000 16.0730000 32.1460000 + 703 703 1 0.0000000 5.3580000 21.4310000 5.3580000 + 704 704 1 0.0000000 5.3580000 21.4310000 10.7150000 + 705 705 1 0.0000000 5.3580000 21.4310000 16.0730000 + 706 706 1 0.0000000 5.3580000 21.4310000 21.4310000 + 707 707 1 0.0000000 5.3580000 21.4310000 26.7880000 + 708 708 1 0.0000000 5.3580000 21.4310000 32.1460000 + 709 709 1 0.0000000 5.3580000 26.7880000 5.3580000 + 710 710 1 0.0000000 5.3580000 26.7880000 10.7150000 + 711 711 1 0.0000000 5.3580000 26.7880000 16.0730000 + 712 712 1 0.0000000 5.3580000 26.7880000 21.4310000 + 713 713 1 0.0000000 5.3580000 26.7880000 26.7880000 + 714 714 1 0.0000000 5.3580000 26.7880000 32.1460000 + 715 715 1 0.0000000 5.3580000 32.1460000 5.3580000 + 716 716 1 0.0000000 5.3580000 32.1460000 10.7150000 + 717 717 1 0.0000000 5.3580000 32.1460000 16.0730000 + 718 718 1 0.0000000 5.3580000 32.1460000 21.4310000 + 719 719 1 0.0000000 5.3580000 32.1460000 26.7880000 + 720 720 1 0.0000000 5.3580000 32.1460000 32.1460000 + 721 721 1 0.0000000 10.7150000 5.3580000 5.3580000 + 722 722 1 0.0000000 10.7150000 5.3580000 10.7150000 + 723 723 1 0.0000000 10.7150000 5.3580000 16.0730000 + 724 724 1 0.0000000 10.7150000 5.3580000 21.4310000 + 725 725 1 0.0000000 10.7150000 5.3580000 26.7880000 + 726 726 1 0.0000000 10.7150000 5.3580000 32.1460000 + 727 727 1 0.0000000 10.7150000 10.7150000 5.3580000 + 728 728 1 0.0000000 10.7150000 10.7150000 10.7150000 + 729 729 1 0.0000000 10.7150000 10.7150000 16.0730000 + 730 730 1 0.0000000 10.7150000 10.7150000 21.4310000 + 731 731 1 0.0000000 10.7150000 10.7150000 26.7880000 + 732 732 1 0.0000000 10.7150000 10.7150000 32.1460000 + 733 733 1 0.0000000 10.7150000 16.0730000 5.3580000 + 734 734 1 0.0000000 10.7150000 16.0730000 10.7150000 + 735 735 1 0.0000000 10.7150000 16.0730000 16.0730000 + 736 736 1 0.0000000 10.7150000 16.0730000 21.4310000 + 737 737 1 0.0000000 10.7150000 16.0730000 26.7880000 + 738 738 1 0.0000000 10.7150000 16.0730000 32.1460000 + 739 739 1 0.0000000 10.7150000 21.4310000 5.3580000 + 740 740 1 0.0000000 10.7150000 21.4310000 10.7150000 + 741 741 1 0.0000000 10.7150000 21.4310000 16.0730000 + 742 742 1 0.0000000 10.7150000 21.4310000 21.4310000 + 743 743 1 0.0000000 10.7150000 21.4310000 26.7880000 + 744 744 1 0.0000000 10.7150000 21.4310000 32.1460000 + 745 745 1 0.0000000 10.7150000 26.7880000 5.3580000 + 746 746 1 0.0000000 10.7150000 26.7880000 10.7150000 + 747 747 1 0.0000000 10.7150000 26.7880000 16.0730000 + 748 748 1 0.0000000 10.7150000 26.7880000 21.4310000 + 749 749 1 0.0000000 10.7150000 26.7880000 26.7880000 + 750 750 1 0.0000000 10.7150000 26.7880000 32.1460000 + 751 751 1 0.0000000 10.7150000 32.1460000 5.3580000 + 752 752 1 0.0000000 10.7150000 32.1460000 10.7150000 + 753 753 1 0.0000000 10.7150000 32.1460000 16.0730000 + 754 754 1 0.0000000 10.7150000 32.1460000 21.4310000 + 755 755 1 0.0000000 10.7150000 32.1460000 26.7880000 + 756 756 1 0.0000000 10.7150000 32.1460000 32.1460000 + 757 757 1 0.0000000 16.0730000 5.3580000 5.3580000 + 758 758 1 0.0000000 16.0730000 5.3580000 10.7150000 + 759 759 1 0.0000000 16.0730000 5.3580000 16.0730000 + 760 760 1 0.0000000 16.0730000 5.3580000 21.4310000 + 761 761 1 0.0000000 16.0730000 5.3580000 26.7880000 + 762 762 1 0.0000000 16.0730000 5.3580000 32.1460000 + 763 763 1 0.0000000 16.0730000 10.7150000 5.3580000 + 764 764 1 0.0000000 16.0730000 10.7150000 10.7150000 + 765 765 1 0.0000000 16.0730000 10.7150000 16.0730000 + 766 766 1 0.0000000 16.0730000 10.7150000 21.4310000 + 767 767 1 0.0000000 16.0730000 10.7150000 26.7880000 + 768 768 1 0.0000000 16.0730000 10.7150000 32.1460000 + 769 769 1 0.0000000 16.0730000 16.0730000 5.3580000 + 770 770 1 0.0000000 16.0730000 16.0730000 10.7150000 + 771 771 1 0.0000000 16.0730000 16.0730000 16.0730000 + 772 772 1 0.0000000 16.0730000 16.0730000 21.4310000 + 773 773 1 0.0000000 16.0730000 16.0730000 26.7880000 + 774 774 1 0.0000000 16.0730000 16.0730000 32.1460000 + 775 775 1 0.0000000 16.0730000 21.4310000 5.3580000 + 776 776 1 0.0000000 16.0730000 21.4310000 10.7150000 + 777 777 1 0.0000000 16.0730000 21.4310000 16.0730000 + 778 778 1 0.0000000 16.0730000 21.4310000 21.4310000 + 779 779 1 0.0000000 16.0730000 21.4310000 26.7880000 + 780 780 1 0.0000000 16.0730000 21.4310000 32.1460000 + 781 781 1 0.0000000 16.0730000 26.7880000 5.3580000 + 782 782 1 0.0000000 16.0730000 26.7880000 10.7150000 + 783 783 1 0.0000000 16.0730000 26.7880000 16.0730000 + 784 784 1 0.0000000 16.0730000 26.7880000 21.4310000 + 785 785 1 0.0000000 16.0730000 26.7880000 26.7880000 + 786 786 1 0.0000000 16.0730000 26.7880000 32.1460000 + 787 787 1 0.0000000 16.0730000 32.1460000 5.3580000 + 788 788 1 0.0000000 16.0730000 32.1460000 10.7150000 + 789 789 1 0.0000000 16.0730000 32.1460000 16.0730000 + 790 790 1 0.0000000 16.0730000 32.1460000 21.4310000 + 791 791 1 0.0000000 16.0730000 32.1460000 26.7880000 + 792 792 1 0.0000000 16.0730000 32.1460000 32.1460000 + 793 793 1 0.0000000 21.4310000 5.3580000 5.3580000 + 794 794 1 0.0000000 21.4310000 5.3580000 10.7150000 + 795 795 1 0.0000000 21.4310000 5.3580000 16.0730000 + 796 796 1 0.0000000 21.4310000 5.3580000 21.4310000 + 797 797 1 0.0000000 21.4310000 5.3580000 26.7880000 + 798 798 1 0.0000000 21.4310000 5.3580000 32.1460000 + 799 799 1 0.0000000 21.4310000 10.7150000 5.3580000 + 800 800 1 0.0000000 21.4310000 10.7150000 10.7150000 + 801 801 1 0.0000000 21.4310000 10.7150000 16.0730000 + 802 802 1 0.0000000 21.4310000 10.7150000 21.4310000 + 803 803 1 0.0000000 21.4310000 10.7150000 26.7880000 + 804 804 1 0.0000000 21.4310000 10.7150000 32.1460000 + 805 805 1 0.0000000 21.4310000 16.0730000 5.3580000 + 806 806 1 0.0000000 21.4310000 16.0730000 10.7150000 + 807 807 1 0.0000000 21.4310000 16.0730000 16.0730000 + 808 808 1 0.0000000 21.4310000 16.0730000 21.4310000 + 809 809 1 0.0000000 21.4310000 16.0730000 26.7880000 + 810 810 1 0.0000000 21.4310000 16.0730000 32.1460000 + 811 811 1 0.0000000 21.4310000 21.4310000 5.3580000 + 812 812 1 0.0000000 21.4310000 21.4310000 10.7150000 + 813 813 1 0.0000000 21.4310000 21.4310000 16.0730000 + 814 814 1 0.0000000 21.4310000 21.4310000 21.4310000 + 815 815 1 0.0000000 21.4310000 21.4310000 26.7880000 + 816 816 1 0.0000000 21.4310000 21.4310000 32.1460000 + 817 817 1 0.0000000 21.4310000 26.7880000 5.3580000 + 818 818 1 0.0000000 21.4310000 26.7880000 10.7150000 + 819 819 1 0.0000000 21.4310000 26.7880000 16.0730000 + 820 820 1 0.0000000 21.4310000 26.7880000 21.4310000 + 821 821 1 0.0000000 21.4310000 26.7880000 26.7880000 + 822 822 1 0.0000000 21.4310000 26.7880000 32.1460000 + 823 823 1 0.0000000 21.4310000 32.1460000 5.3580000 + 824 824 1 0.0000000 21.4310000 32.1460000 10.7150000 + 825 825 1 0.0000000 21.4310000 32.1460000 16.0730000 + 826 826 1 0.0000000 21.4310000 32.1460000 21.4310000 + 827 827 1 0.0000000 21.4310000 32.1460000 26.7880000 + 828 828 1 0.0000000 21.4310000 32.1460000 32.1460000 + 829 829 1 0.0000000 26.7880000 5.3580000 5.3580000 + 830 830 1 0.0000000 26.7880000 5.3580000 10.7150000 + 831 831 1 0.0000000 26.7880000 5.3580000 16.0730000 + 832 832 1 0.0000000 26.7880000 5.3580000 21.4310000 + 833 833 1 0.0000000 26.7880000 5.3580000 26.7880000 + 834 834 1 0.0000000 26.7880000 5.3580000 32.1460000 + 835 835 1 0.0000000 26.7880000 10.7150000 5.3580000 + 836 836 1 0.0000000 26.7880000 10.7150000 10.7150000 + 837 837 1 0.0000000 26.7880000 10.7150000 16.0730000 + 838 838 1 0.0000000 26.7880000 10.7150000 21.4310000 + 839 839 1 0.0000000 26.7880000 10.7150000 26.7880000 + 840 840 1 0.0000000 26.7880000 10.7150000 32.1460000 + 841 841 1 0.0000000 26.7880000 16.0730000 5.3580000 + 842 842 1 0.0000000 26.7880000 16.0730000 10.7150000 + 843 843 1 0.0000000 26.7880000 16.0730000 16.0730000 + 844 844 1 0.0000000 26.7880000 16.0730000 21.4310000 + 845 845 1 0.0000000 26.7880000 16.0730000 26.7880000 + 846 846 1 0.0000000 26.7880000 16.0730000 32.1460000 + 847 847 1 0.0000000 26.7880000 21.4310000 5.3580000 + 848 848 1 0.0000000 26.7880000 21.4310000 10.7150000 + 849 849 1 0.0000000 26.7880000 21.4310000 16.0730000 + 850 850 1 0.0000000 26.7880000 21.4310000 21.4310000 + 851 851 1 0.0000000 26.7880000 21.4310000 26.7880000 + 852 852 1 0.0000000 26.7880000 21.4310000 32.1460000 + 853 853 1 0.0000000 26.7880000 26.7880000 5.3580000 + 854 854 1 0.0000000 26.7880000 26.7880000 10.7150000 + 855 855 1 0.0000000 26.7880000 26.7880000 16.0730000 + 856 856 1 0.0000000 26.7880000 26.7880000 21.4310000 + 857 857 1 0.0000000 26.7880000 26.7880000 26.7880000 + 858 858 1 0.0000000 26.7880000 26.7880000 32.1460000 + 859 859 1 0.0000000 26.7880000 32.1460000 5.3580000 + 860 860 1 0.0000000 26.7880000 32.1460000 10.7150000 + 861 861 1 0.0000000 26.7880000 32.1460000 16.0730000 + 862 862 1 0.0000000 26.7880000 32.1460000 21.4310000 + 863 863 1 0.0000000 26.7880000 32.1460000 26.7880000 + 864 864 1 0.0000000 26.7880000 32.1460000 32.1460000 + diff --git a/examples/gjf/ff-argon.lmp b/examples/gjf/ff-argon.lmp new file mode 100644 index 0000000000..b6f7bc931a --- /dev/null +++ b/examples/gjf/ff-argon.lmp @@ -0,0 +1,20 @@ +############################# +#Atoms types - mass - charge# +############################# +#@ 1 atom types #!THIS LINE IS NECESSARY DON'T SPEND HOURS FINDING THAT OUT!# + +variable Ar equal 1 + +############# +#Atom Masses# +############# + +mass ${Ar} 39.903 + +########################### +#Pair Potentials - Tersoff# +########################### + +pair_style lj/cubic +pair_coeff * * 0.0102701 3.42 + diff --git a/examples/gjf/in.argon b/examples/gjf/in.argon new file mode 100644 index 0000000000..271882c665 --- /dev/null +++ b/examples/gjf/in.argon @@ -0,0 +1,162 @@ +###############################mm +# Atom style - charge/vdw/bonded# +################################# +atom_style full + +############################################## +#Units Metal : eV - ps - angstrom - bar# +# Real : kcal/mol - fs - angstrom - atm# +############################################## +units metal + +############ +#Run number# +############ +variable run_no equal 0 # is it a restart? +variable res_no equal ${run_no}-1 # restart file number + +####################################### +#Random Seeds and Domain Decomposition# +####################################### +variable iseed0 equal 2357 +variable iseed1 equal 26488 +variable iseed2 equal 10669 +processors * * * + +########### +#Data File# +########### +variable inpfile string argon.lmp +variable resfile string final_restart.${res_no} +variable ff_file string ff-argon.lmp + +########## +#Run Type# +########## +variable minimise equal 0 #Energy Minimization +variable md equal 1 #Plain MD + +############################### +#Molecular Dynamics Parameters# +############################### +variable run_no equal 0 # is it a restart? + +variable ens equal 9 # ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres, 7=stoch, 8=gjf) +variable ts equal 0.120 # simulation timestep (time units) +variable nequil equal 0 # number of equilibration steps +variable nsteps equal 200000 # number of MD steps +#variable nsteps equal 20 # number of MD steps + +variable temp_s equal 10 # starting temperature +variable temp_f equal 10 # final simulation temperature +variable trel equal 1 # thermostat relaxation time +variable tscale equal 1 # thermostat relaxation freq - vel rescaling only +variable deltat equal 1 # maximum temperature change - vel rescaling only + +variable npttype string iso # type of NPT (iso, aniso, tri, z...) +variable pres equal 1.01325 # pressure (NPT runs only) +variable prel equal 1.0 # barostat relaxation time + +neighbor 1 bin + +################### +#Output Parameters# +################### +variable ntraj equal 1000 # trajectory output frequency - all system +variable ntraj_s equal -100 # trajectory output frequency - solute only +variable nthermo equal 200 # thermodynamic data output frequency + +################################ +#Energy Minimization Parameters# +################################ +variable mtraj equal 1 # trajectory output frequency - all system +variable etol equal 1e-5 # % change in energy +variable ftol equal 1e-5 # max force threshold (force units) +variable maxiter equal 10000 # max # of iterations + +######################## +#3D Periodic Simulation# +######################## +boundary p p p + +############################# +#Reading the input structure# +############################# +if "${run_no} == 0" then "read_data ${inpfile}" else "read_restart ${resfile}" + +############# +#Force Field# +############# +include ${ff_file} + +###################### +#Thermodynamic Output# +###################### +variable str_basic string 'step time pe temp press' + +#MD ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres) +variable str_ens string ' ' +if "${ens} == 0" then "variable str_ens string 'etotal'" +if "${ens} == 2" then "variable str_ens string 'vol pxx pyy pzz cella cellb cellc cellakpha cellbeta cellgamma'" + +#Variable for a gulp friend output +if "${ens} >= 0" then "thermo_style custom time temp pe etotal press vol cpu" & + "thermo ${nthermo}" & + "thermo_modify flush yes" + +##################### +#Energy Minimization# +##################### +if "${minimise} <= 0 || ${run_no} > 0" then "jump SELF end_minimise" + print "Doing CG minimisation" + dump mdcd all dcd ${mtraj} min.dcd + dump_modify mdcd unwrap yes + min_style cg + min_modify line quadratic + minimize ${etol} ${ftol} ${maxiter} ${maxiter} + reset_timestep 0 + undump mdcd +label end_minimise + +################ +#Timestep in ps# +################ +timestep ${ts} + +############## +#Restart file# +############## +restart 100000 restart.1 restart.2 + +################### +#Trajectory output# +################### +#dump xyz all atom 1000 silicon.lammpstrj + +if "${ntraj} > 0" then & + "dump 1 all dcd ${ntraj} trajectory.${run_no}.dcd" & + "dump_modify 1 unwrap yes" + +fix mom all momentum 1 linear 1 1 1 + +############################################################### +#Ensembles (0=nve,1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres)# +############################################################### +if "${md} > 0" then 'print "Setting up the ensembles"' & + 'if "${run_no} == 0" then "velocity all create ${temp_s} ${iseed0} mom yes dist gaussian"' & + 'if "${ens} == 0" then "fix nve all nve"' & + 'if "${ens} == 1" then "fix nvt all nvt temp ${temp_s} ${temp_f} ${trel} tchain 5"' & + 'if "${ens} == 2" then "fix npt all npt temp ${temp_s} ${temp_f} ${trel} ${npttype} ${pres} ${pres} ${prel} tchain 5 pchain 5 mtk yes"' & + 'if "${ens} == 3" then "fix nve all nve" "fix ber all temp/berendsen ${temp_s} ${temp_f} ${trel}"' & + 'if "${ens} == 4" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} tally yes zero yes"' & + 'if "${ens} == 5" then "fix nve all nve" "fix stoch all temp/csvr ${temp_s} ${temp_f} ${trel} ${iseed1}"' & + 'if "${ens} == 6" then "fix nve all nve" "fix stoch all temp/csld ${temp_s} ${temp_f} ${trel} ${iseed1}"' & + 'if "${ens} == 7" then "fix nve all nve" "fix vres all temp/rescale ${tscale} ${temp_s} ${temp_f} ${tmin} ${tmax}"' & + 'if "${ens} == 8" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes"' & + 'if "${ens} == 9" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes halfstep yes"' + +if "${md} > 0" then "print 'Doing Molecular dynamics'" & + "run ${nsteps}" & + "write_restart final_restart.${run_no}" + + diff --git a/examples/gjf/out.argon b/examples/gjf/out.argon new file mode 100644 index 0000000000..8dda569157 --- /dev/null +++ b/examples/gjf/out.argon @@ -0,0 +1,249 @@ +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 +Reading data file ... + orthogonal box = (0 0 0) to (32.146 32.146 32.146) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 864 atoms +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors +Setting up the ensembles +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +Doing Molecular dynamics +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.94072 + ghost atom cutoff = 6.94072 + binsize = 3.47036, bins = 10 10 10 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cubic, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard +Setting up Verlet run ... + Unit style : metal + Current step : 0 + Time step : 0.12 +Per MPI rank memory allocation (min/avg/max) = 6.847 | 6.847 | 6.847 Mbytes +Time Temp PotEng TotEng Press Volume CPU + 0 10 -56.207655 -55.09214 33.340921 33218.561 0 + 24 10.156356 -55.092888 -53.959932 339.40964 33218.561 0.082175482 + 48 9.6121006 -55.07262 -54.000376 344.56765 33218.561 0.19529325 + 72 9.8187467 -55.16687 -54.071574 318.85979 33218.561 0.29643488 + 96 9.5421385 -55.151229 -54.086789 322.8842 33218.561 0.38801357 + 120 10.295035 -55.12919 -53.980763 332.00171 33218.561 0.47607262 + 144 10.331608 -55.09907 -53.946563 339.28896 33218.561 0.57389224 + 168 10.154698 -55.058246 -53.925475 349.03253 33218.561 0.65481471 + 192 9.858198 -55.127583 -54.027886 330.09298 33218.561 0.74437734 + 216 9.6658918 -55.10812 -54.029875 334.28383 33218.561 0.8278495 + 240 9.6801591 -55.102386 -54.02255 336.27242 33218.561 0.91167379 + 264 10.685658 -55.046238 -53.854237 355.0448 33218.561 1.0023789 + 288 10.387727 -55.08427 -53.925504 343.87247 33218.561 1.0960371 + 312 10.231132 -55.120428 -53.97913 333.22463 33218.561 1.2382998 + 336 10.20896 -55.075142 -53.936317 344.88438 33218.561 1.3420489 + 360 9.7876538 -55.165008 -54.07318 319.14962 33218.561 1.42782 + 384 9.9872551 -55.13881 -54.024717 327.82471 33218.561 1.5417666 + 408 9.5362734 -55.063733 -53.999947 346.50545 33218.561 1.6328366 + 432 10.262638 -55.126608 -53.981796 332.16342 33218.561 1.7242996 + 456 9.9228239 -55.122119 -54.015214 332.26261 33218.561 1.8124888 + 480 9.7026324 -55.17057 -54.088227 317.84818 33218.561 1.900233 + 504 10.028762 -55.082465 -53.963741 343.04257 33218.561 1.989605 + 528 9.8227851 -55.121222 -54.025476 332.42857 33218.561 2.0708802 + 552 10.208672 -55.100242 -53.961449 338.68109 33218.561 2.1527217 + 576 10.180849 -55.124065 -53.988376 331.29516 33218.561 2.238126 + 600 9.6467252 -55.119533 -54.043427 332.43109 33218.561 2.323443 + 624 10.041885 -55.173802 -54.053614 318.48579 33218.561 2.4046151 + 648 10.151597 -55.111725 -53.979299 334.66227 33218.561 2.4902161 + 672 9.7719111 -55.060111 -53.970039 348.55249 33218.561 2.5800372 + 696 10.476688 -55.088109 -53.919419 342.94922 33218.561 2.6731395 + 720 10.517805 -55.113604 -53.940327 335.47342 33218.561 2.760651 + 744 10.006466 -55.045085 -53.928848 353.53813 33218.561 2.8537894 + 768 10.201492 -55.081598 -53.943606 343.3206 33218.561 2.9404115 + 792 10.117738 -55.077806 -53.949157 345.31093 33218.561 3.030765 + 816 10.362288 -55.11635 -53.960421 333.9045 33218.561 3.1177356 + 840 10.204164 -55.097619 -53.959329 338.82717 33218.561 3.2091886 + 864 10.147722 -55.101372 -53.969378 338.19682 33218.561 3.3003742 + 888 9.9265037 -55.111394 -54.004077 334.08116 33218.561 3.395341 + 912 10.206403 -55.132181 -53.993642 328.89904 33218.561 3.4882881 + 936 10.28639 -55.093317 -53.945855 340.61244 33218.561 3.5764735 + 960 9.8028822 -55.078802 -53.985276 343.5904 33218.561 3.7056267 + 984 10.492755 -55.121321 -53.950839 334.62697 33218.561 3.8055611 + 1008 10.621569 -55.088588 -53.903736 343.33166 33218.561 3.9144807 + 1032 10.006729 -55.113459 -53.997193 334.43025 33218.561 4.0189888 + 1056 10.099853 -55.068035 -53.941381 347.42158 33218.561 4.1391664 + 1080 10.254232 -55.066685 -53.92281 347.15777 33218.561 4.2443953 + 1104 9.9495142 -55.13686 -54.026977 327.63107 33218.561 4.3368342 + 1128 10.377108 -55.08846 -53.930878 344.13083 33218.561 4.4287748 + 1152 10.036981 -55.114643 -53.995003 334.88053 33218.561 4.526868 + 1176 10.144779 -55.097125 -53.965459 339.698 33218.561 4.6614049 + 1200 10.075844 -55.14695 -54.022974 326.05911 33218.561 4.799835 + 1224 10.183695 -55.121716 -53.98571 332.75772 33218.561 4.8908897 + 1248 10.581369 -55.027954 -53.847587 359.06251 33218.561 4.9839788 + 1272 10.158269 -55.105173 -53.972003 337.52964 33218.561 5.0918646 + 1296 9.8776072 -55.064085 -53.962223 347.15648 33218.561 5.2291209 + 1320 10.38161 -55.118366 -53.960282 335.17767 33218.561 5.3570446 + 1344 9.9528146 -55.141937 -54.031685 326.27117 33218.561 5.4584705 + 1368 9.8024326 -55.117808 -54.024332 332.99835 33218.561 5.5557818 + 1392 10.35447 -55.110235 -53.955179 336.80412 33218.561 5.6467392 + 1416 10.199061 -55.105641 -53.96792 337.36785 33218.561 5.7476527 + 1440 9.6868779 -55.087316 -54.00673 340.9166 33218.561 5.8432207 + 1464 10.093238 -55.049436 -53.92352 352.27563 33218.561 5.9471521 + 1488 9.7578808 -55.123935 -54.035429 329.93926 33218.561 6.0495014 + 1512 10.099979 -55.205426 -54.078758 309.26166 33218.561 6.1612976 + 1536 10.172944 -55.087106 -53.952299 342.93395 33218.561 6.2506202 + 1560 10.51771 -55.107635 -53.934369 340.1967 33218.561 6.3379856 + 1584 10.044994 -55.101362 -53.980828 339.03163 33218.561 6.4362567 + 1608 9.624758 -55.146246 -54.07259 324.32486 33218.561 6.5385845 + 1632 9.9135215 -55.097278 -53.99141 338.69162 33218.561 6.6452786 + 1656 9.863681 -55.070523 -53.970214 345.84608 33218.561 6.7518212 + 1680 10.138513 -55.127065 -53.996099 330.40757 33218.561 6.8775188 + 1704 10.382237 -55.070572 -53.912417 347.074 33218.561 7.0126448 + 1728 10.72487 -55.081147 -53.884771 345.83623 33218.561 7.1384216 + 1752 9.829431 -55.131041 -54.034553 328.57652 33218.561 7.2616419 + 1776 9.9135662 -55.100556 -53.994682 336.52238 33218.561 7.4193201 + 1800 10.41873 -55.097116 -53.934891 340.24798 33218.561 7.5570544 + 1824 10.151782 -55.03231 -53.899864 357.3654 33218.561 7.6872905 + 1848 10.42307 -55.043808 -53.881099 355.71677 33218.561 7.7933885 + 1872 10.276862 -55.085016 -53.938616 344.46273 33218.561 7.8887472 + 1896 9.7681373 -55.146507 -54.056857 324.84323 33218.561 7.9977923 + 1920 9.6624824 -55.103214 -54.025349 336.06397 33218.561 8.090235 + 1944 10.153504 -55.049175 -53.916536 352.36339 33218.561 8.1923703 + 1968 10.191954 -55.098741 -53.961813 338.8667 33218.561 8.3320906 + 1992 9.92167 -55.117079 -54.010302 332.96497 33218.561 8.4774437 + 2016 9.5737281 -55.091141 -54.023178 339.41837 33218.561 8.6149527 + 2040 10.600908 -55.092717 -53.91017 342.71852 33218.561 8.7639523 + 2064 9.9214513 -55.099904 -53.993151 337.46799 33218.561 8.898087 + 2088 9.9256258 -55.082224 -53.975005 342.85042 33218.561 9.0130784 + 2112 10.345379 -55.112923 -53.95888 335.81471 33218.561 9.1422766 + 2136 9.8876649 -55.079254 -53.97627 343.05764 33218.561 9.2885707 + 2160 10.04492 -55.074876 -53.95435 344.82419 33218.561 9.3876103 + 2184 10.028705 -55.063961 -53.945244 347.70549 33218.561 9.500967 + 2208 10.412572 -55.136316 -53.974778 329.8188 33218.561 9.5900362 + 2232 10.404205 -55.09913 -53.938525 339.77542 33218.561 9.7048353 + 2256 9.5694135 -55.139021 -54.071538 326.37473 33218.561 9.8045958 + 2280 10.244745 -55.134529 -53.991713 329.19392 33218.561 9.8968908 + 2304 9.9129922 -55.116192 -54.010382 333.14326 33218.561 9.9818651 + 2328 10.167027 -55.08241 -53.948263 343.08135 33218.561 10.068683 + 2352 10.262045 -55.144327 -53.999581 327.40876 33218.561 10.155937 + 2376 10.520934 -55.073147 -53.899521 347.6998 33218.561 10.246316 + 2400 9.9628692 -55.122001 -54.010628 331.25369 33218.561 10.336833 + 2424 10.565531 -55.157113 -53.978512 325.14897 33218.561 10.452039 + 2448 10.03709 -55.096409 -53.976756 338.29607 33218.561 10.537936 + 2472 9.384311 -55.141821 -54.094987 324.23247 33218.561 10.628689 + 2496 9.8019362 -55.105685 -54.012264 335.97239 33218.561 10.717287 + 2520 10.31114 -55.078831 -53.928608 345.42395 33218.561 10.818756 + 2544 10.407237 -55.148382 -53.987439 325.94421 33218.561 10.910801 + 2568 10.257967 -55.041348 -53.897056 355.73261 33218.561 11.004221 + 2592 9.8425807 -55.139428 -54.041474 328.28096 33218.561 11.101295 + 2616 10.140697 -55.100238 -53.969028 338.76319 33218.561 11.192211 + 2640 9.7102818 -55.136288 -54.053091 326.7053 33218.561 11.280277 + 2664 10.120372 -55.128779 -53.999836 330.71707 33218.561 11.369001 + 2688 10.232537 -55.120614 -53.979159 333.35087 33218.561 11.464652 + 2712 10.032526 -55.094761 -53.975618 339.97984 33218.561 11.559387 + 2736 9.8791 -55.121998 -54.01997 332.32556 33218.561 11.649679 + 2760 9.891483 -55.120919 -54.017509 331.32614 33218.561 11.742604 + 2784 10.201053 -55.165525 -54.027582 320.39272 33218.561 11.85274 + 2808 10.238648 -55.096449 -53.954312 340.06316 33218.561 11.939782 + 2832 9.8692851 -55.068632 -53.967699 346.77535 33218.561 12.036655 + 2856 10.179976 -55.128413 -53.992822 331.5662 33218.561 12.123227 + 2880 9.7656315 -55.1468 -54.057429 324.02612 33218.561 12.213117 + 2904 9.7991628 -55.049191 -53.95608 352.45738 33218.561 12.326761 + 2928 10.581767 -55.093293 -53.912881 341.37292 33218.561 12.417633 + 2952 10.546144 -55.07452 -53.898081 347.02025 33218.561 12.52701 + 2976 9.8306008 -55.14762 -54.051002 323.45715 33218.561 12.633522 + 3000 10.033532 -55.076433 -53.957178 345.36812 33218.561 12.72627 + 3024 10.046266 -55.085775 -53.965099 342.47786 33218.561 12.816242 + 3048 10.176777 -55.133013 -53.997778 329.04144 33218.561 12.903175 + 3072 9.9778064 -55.143787 -54.030748 326.75284 33218.561 13.014329 + 3096 10.516223 -55.110144 -53.937043 336.802 33218.561 13.104673 + 3120 9.6561157 -55.138699 -54.061544 325.6652 33218.561 13.207371 + 3144 10.237043 -55.060968 -53.91901 349.44011 33218.561 13.303442 + 3168 9.9704264 -55.123073 -54.010857 332.19725 33218.561 13.391877 + 3192 10.493307 -55.144402 -53.973858 327.15485 33218.561 13.482857 + 3216 10.022171 -55.141782 -54.023794 326.08249 33218.561 13.574484 + 3240 9.6957248 -55.137865 -54.056292 326.04858 33218.561 13.671408 + 3264 9.9685299 -55.124301 -54.012297 331.9015 33218.561 13.760186 + 3288 10.413707 -55.153604 -53.99194 324.32939 33218.561 13.877604 + 3312 10.022953 -55.103422 -53.985346 337.52066 33218.561 13.977562 + 3336 10.044478 -55.110297 -53.98982 334.48379 33218.561 14.065563 + 3360 9.8593734 -55.130623 -54.030795 327.71748 33218.561 14.15952 + 3384 9.9269422 -55.107979 -54.000613 335.18173 33218.561 14.258064 + 3408 10.288049 -55.092276 -53.944629 340.71484 33218.561 14.36211 + 3432 9.9702156 -55.08732 -53.975128 341.72171 33218.561 14.452123 + 3456 10.246178 -55.091669 -53.948692 341.62844 33218.561 14.555775 + 3480 10.559292 -55.086917 -53.909012 343.70626 33218.561 14.645718 + 3504 10.652207 -55.050897 -53.862628 354.46979 33218.561 14.797422 + 3528 9.9835266 -55.0557 -53.942023 350.74747 33218.561 14.895716 + 3552 10.240934 -55.123217 -53.980825 332.26434 33218.561 15.023796 + 3576 10.406519 -55.093536 -53.932674 341.54029 33218.561 15.203252 + 3600 10.406733 -55.095168 -53.934282 341.22192 33218.561 15.303986 + 3624 9.9877484 -55.154231 -54.040083 323.55633 33218.561 15.398883 + 3648 10.391829 -55.110208 -53.950984 337.09219 33218.561 15.49042 + 3672 10.368995 -55.069591 -53.912914 346.82649 33218.561 15.582259 + 3696 10.362939 -55.109012 -53.953011 337.32216 33218.561 15.679316 + 3720 10.465254 -55.136214 -53.968799 331.22288 33218.561 15.773303 + 3744 9.8238226 -55.10114 -54.005278 338.12616 33218.561 15.86905 + 3768 10.205504 -55.101263 -53.962824 339.04196 33218.561 15.960072 + 3792 9.9589987 -55.118883 -54.007942 332.84318 33218.561 16.047055 + 3816 10.253382 -55.117513 -53.973732 334.42101 33218.561 16.148412 + 3840 10.262393 -55.069549 -53.924764 349.084 33218.561 16.235391 + 3864 9.7367167 -55.078288 -53.992142 342.48207 33218.561 16.329112 + 3888 10.171202 -55.134701 -54.000088 329.5847 33218.561 16.415353 + 3912 10.01925 -55.145139 -54.027477 326.65074 33218.561 16.526334 + 3936 10.053638 -55.038151 -53.916653 355.74893 33218.561 16.618524 + 3960 10.044055 -55.058382 -53.937953 349.01834 33218.561 16.712577 + 3984 10.382422 -55.099216 -53.941041 339.28099 33218.561 16.79941 + 4008 9.97927 -55.09284 -53.979637 339.07225 33218.561 16.904198 + 4032 9.6782319 -55.126143 -54.046522 329.0201 33218.561 16.991454 + 4056 9.6593809 -55.123677 -54.046159 329.89833 33218.561 17.097172 + 4080 10.442896 -55.141149 -53.976229 327.9899 33218.561 17.189364 + 4104 9.9571109 -55.08588 -53.975149 341.3746 33218.561 17.294147 + 4128 10.44943 -55.087946 -53.922296 343.09435 33218.561 17.387357 + 4152 10.040581 -55.171939 -54.051897 317.85348 33218.561 17.500905 + 4176 10.089442 -55.128713 -54.00322 330.29121 33218.561 17.588891 + 4200 10.316156 -55.123219 -53.972436 333.59382 33218.561 17.679254 + 4224 10.177245 -55.095671 -53.960384 339.34498 33218.561 17.770569 + 4248 9.7129183 -55.135335 -54.051844 328.25125 33218.561 17.857728 + 4272 10.231838 -55.099554 -53.958177 339.64015 33218.561 17.944226 + 4296 9.9737677 -55.117885 -54.005297 333.07248 33218.561 18.034105 + 4320 10.004955 -55.116155 -54.000088 333.52271 33218.561 18.129644 + 4344 9.5938901 -55.133824 -54.063612 327.84171 33218.561 18.215476 + 4368 9.8954562 -55.131603 -54.02775 329.0813 33218.561 18.306539 + 4392 10.439732 -55.100379 -53.935812 339.81679 33218.561 18.395651 + 4416 9.934513 -55.08449 -53.97628 341.74441 33218.561 18.484506 + 4440 10.025998 -55.136771 -54.018356 327.73718 33218.561 18.593946 + 4464 9.9304451 -55.101817 -53.994061 338.1801 33218.561 18.684011 + 4488 10.344371 -55.085856 -53.931926 342.91721 33218.561 18.782399 + 4512 10.033193 -55.091778 -53.972561 339.85728 33218.561 18.879666 + 4536 9.2361614 -55.169375 -54.139067 316.67597 33218.561 18.983667 + 4560 9.5786289 -55.179976 -54.111465 314.76415 33218.561 19.079009 + 4584 10.071651 -55.107218 -53.98371 336.10364 33218.561 19.163975 + 4608 9.9873098 -55.109348 -53.995249 336.03665 33218.561 19.25635 + 4632 10.143888 -55.119423 -53.987857 333.74978 33218.561 19.346658 + 4656 9.7506264 -55.114772 -54.027075 332.98271 33218.561 19.435425 + 4680 9.9616769 -55.096054 -53.984814 339.20499 33218.561 19.55562 + 4704 10.271313 -55.074522 -53.928742 345.87397 33218.561 19.642652 + 4728 9.9172336 -55.098805 -53.992523 338.06318 33218.561 19.734557 + 4752 9.9556222 -55.12128 -54.010716 332.66408 33218.561 19.83859 + 4776 10.197593 -55.095293 -53.957736 339.50067 33218.561 19.947471 + 4800 10.145085 -55.108467 -53.976768 336.05115 33218.561 20.044183 + 4824 10.205523 -55.147376 -54.008934 325.56559 33218.561 20.144393 + 4848 9.8900281 -55.121598 -54.01835 331.17401 33218.561 20.243197 + 4872 10.03655 -55.100936 -53.981343 337.6777 33218.561 20.336043 + 4896 9.8120635 -55.087507 -53.992957 341.42438 33218.561 20.425498 + 4920 10.615354 -55.093335 -53.909176 342.30776 33218.561 20.519318 + 4944 10.374366 -55.06455 -53.907274 351.10607 33218.561 20.612312 + 4968 10.677474 -55.147807 -53.956718 327.85703 33218.561 20.719371 + 4992 10.558882 -55.145253 -53.967393 327.427 33218.561 20.818726 + 5016 9.4097946 -55.150835 -54.101158 321.62641 33218.561 20.914472 diff --git a/examples/gjf/trajectory.0.dcd b/examples/gjf/trajectory.0.dcd new file mode 100644 index 0000000000000000000000000000000000000000..47927e9909cfcfc86ceb2568ba1660efed5834f2 GIT binary patch literal 439092 zcmeEubx>P-)a?m%rApmsu_RbsfbNyL3nZbgw72dqgu2rf66!*Wph-<^4HzCT{SnRe#fz`5b@<0pHsz1G?Z5d@)KufFZ2{QB$P>mq{S zx$A#^`5*ohne`=5@*nR0#~ao8RtR5v`Eue*J$20V>0uM=51&)NJ9_l!9nAOsEC2d- z=z+f7g6p@N8a8Zt*vR_+t?GB3F@BD`u^)dmY(-ooB;CH&xri%ET zuA4oq_?@ow=`!BWzt1%zO2F@Q-Rz;__4<9T8bx*Zovt>IO!%FyvFSGaPS@{rwtkJ} zcRE|Y#_~IztzTpLozB*;vHVVF>(^L*r?d5IEWZyj{Cgz76E^%cmfr~*{u;~ggbja< z<#)n{zsB-AVZ&cz`Bj7cy8bPX{aZfyx48aq@%7*0+`q+}KjZlucm0{4zwz*Y|NZly z^9uhKzyB?c{#!izx406a6%_y3^>2CX&v^cxuRrtiH;?h3?VVrue!uzo&pD1i`Rng` z`AwmAq{^8C3;fH?J0RM1%|8Q9Ua5aDK z|IJzbnTJ2~@aMez&A0!Vhd=Z1|1Tc?%}M{mz5bJf|KY0t-2XE_|L_O@=mr1q;(zY{ ztq=T}hd=Z1CrXpm(Y^Am!1@=C8=JhlmhR%a#ke$om+@u8W5&4T8^#Y` zoijr9a{~siOAZXaC=2*xhzXqXBRk#p$|e0-?qXx>Dl?56{Er64F4+~BwoYq&xMO{w z-?^fJx+UR(`$BvIr>{>Ae7df6z_=CF(^p>$HokaVGH}(bqv>1RPa2~ZA5ZTX*|<%& zw+Y6ge!Bvve|i-7zar8sq2G8`u^Xug3{n85=5-DollSAt##j;B>3>qcJ`&LpsnJ>fDZBm>Llp!UVy_6lL_&8jO zOD*M)?2;kOKLVMEz@2~yTzjR##UdJvpRB=kYmM&@~kE2TVQBvfvnJiz78t}b+cl!s};M{RtS@=2>)(@ z`Mw2Dy72oV`E`i}m#$mk+0KH`v#nU9v|_8t0!MQzKJ3ZH#urvZTP<)sW5v#4R$PB( zL9tH0)X*-cjVpZU&~Z;{V09(0=1s`?jwhA)+K_%u^`^v{Ze$$jP8~+esq;Z8#gF%< zBQCy_(a?*2UTaQaUd^fTTwf|$LQdU}HK6IwdRlm}Z{6D+V z?j16!e_Bpube_~_mIpQN=tdJ}xYGP8a+)#Pk8-mMsdGC4g{=#zl#_t0>xDF`xddwucTlxd2PM~+VEy?} z+`rrpYnS!I&^jSVa8g0nUX8o0RTwc*3F~t;BBrX)y@nD!SB2nuloB=Ph9ES~; zimy>YdQ^q4$3l@cQw>+O3Om;X<3)f9p@k}hPg0@xLN#8VP@;=G1T{;kvAKj2i&m>) z<>&7AP~kxN5EQMa!u*#iOzN-2fnz!}?HL2@LmfsO*J5rj9hxU;vFU&gmlZlRiq_#% z10Cj;(jl?54(9^3i1XFLRU3_%3R)cY(V_8kEo?P)XfacV_K{jVpQA;sfm$q|sfFLK z=QPn_$zd%@6>2f8l@3z=9iQ&$kbF~z{RKLd=o^EeTrG~4FvGFjgarposI}XSEsxDO z^3#L^uT3ztF`?X66TVh4A^cq?R8vi;KGTf1rOjx2)`VkS&4^l(iD&0BK_ktm`6v@b z@0c*Aml*~Z6NC!)2%)O$;_%cw|Gp+IFPP%7JNt4Ks_` z(QByooK_hoE*3{vq9x-$6u4|c-h>JaxpfNBS2qDg4;8GlI@xV z?t=u3kC31QpPNs$1(eS#q$xoH+-?fE(b+*MLLm)XQb?uS7Sh@1-|R09?ItWaV=MS!OR1U$7}H%1q_&wOZuA(ZO|`4xdkG z(e{BBg%$YcqqTUmUk9(TI?R}%#oj?$M4r~-r(O%y2_0fP#UQL=48D5n;9}I`VJbgY zn}y!dCXDN3hIXeJ>lT`Dkk8!K875pYW}?keGae^o;qnPSLoZDb4w+DIxCxWyn31*A zghp}vvzeJZPbTDEG$H%32@9v05MwgIZ?g&G`MjO3YR1*=CKP-#!DW&e&)S-?rg9d} z$;=!}%xF>Bj8wG=8#N}pt6;;vB{mdpx1o7k8>*DEq1*>EYz4n4mf8g9c}y$v@UIS6lJ zgTBy)obfg^`Iv(x={776%99&9|++B?19+AyQa`IfQd)pEw^ zD}MykKD8#`_4(QXVV(m5;&+ZUmP-f=+&k;@iT97+rN3+RDLt()<;2s0D+A-d8v{2M z>ze+odX$`KXH~Lm3ANN+whG@yZKpt7k+G`m$2J-nVs&5P;DxZgmdoDylt z?L=C1Gm&$iNJXyb>GkY1YHv)Y1G;1yo^GJ^u8EYSHBkBaNfdc1nfhJR(|UOlZ7wcS z&>cP9SeHzZIzmbBYBRsETwdCS|O6pnq=y|IGJ*T4HSG? zibFqSc-}{bB3r%SS4#^03ON?+_r@NH96!IxaBiFo@88H!r7Qalo67OIryR@r%iujm z3Xd6HxLrYppsF(1S9!s8ycA_i%3$>OM&qk8ge>wzpIb7_GDzWCSBk@sggRwA}Aeyhd!F0_~dy`M1#93*1!C_NlyL>zv`IFg_B@-Smb zlOEJvMCw`*9W)|JToSRGzdp*iFp-~On9jJ<*MNm<40yIpM5loU^y1&wzm^D9pam|= zEht&aigPovQ6t!jF}tl;UEhLXdACq!niYYSt;j#cSg@xB1DjY;ow20xwiRWZtVmsK z#hxe&&iY!hILv~h@fJ+DVSyk2zc>8e3qP$GcisXF%frYE^WwfcOH&se^&^^XhTSgR+Uke9` z!4ArD7LdZ;@GbAvDCMU{SQ{1IWQV}1w-VWBwWyk=#T1Jc5sWibjkVY|Fb1t_n9-zx z2}X?>@`6k(Ich@Hsb)0bIB*&^)Gn}LK^+_RF6S7K%V*zHN_ZzD*SY>QQ^)!7rZ>Hf zlv0hF1vFw#0X^IzU~E7k>5~N1>mWgtnd5u~HTI2DLH&*M%;gYt@KR&+869Gd=org$ z9M052J6ns`k~%D(WyaL`CS2WQf-J^_E8-4NoNlQWm%zrPz=+zQD@^DaH#;QAg`{B)JC05=J zL1o5~_8w}8ob&4SkKvr8L%E(h%x3JBR8@yl={ls|HsL*wq46LyigTQw*xif^pG+t{ z!HyanV@t2%I2mNaF2*&Ub8Kkz)Qvi~_oU4AGTNQwLt|$7(&|o4=mq27LG2}&A{S83 zPy}=@{<;oCfSR^f|>8mhKxBwN4J)pX4BE zr457L%4qfyciPykDQ#`slsZ3hBUu?A8g7+fd0k$w0Y#7zEWyC@PIx1A;u=r|d6y8p zAFsr)bTx)IQ(^D{HT*e$uRj}&p3gYvkJqAE865_3{x8>>=V!19yRMo*3KLAvP3Uhl z;REB--4An+=4XTAnhom295lPfzWik(-SRY$=4%Qa_fMk0N_uKh#z5{)9D8?oVLr#= z`PJp9+FFY0XQimnm%Z4>G`PMu97A$7_&QjFJ)<;m_7u@=j~-9Y=ppN>hxomMn&WJR+`D_Y8}comq9xZ#4rHbqcWlt~mXCkl$#k`jgI89{NeOcH&+sHfOr zDWpkGpz^y!GOLm({;m{0O}*gJObSS)xYtXD_=9phB>ubLGbs#+oPxV~Ms;L9zpgEv~y?w+6+-$PLJ_$ep` z$R&z1vjxTe6hX18auPMXmq^ZgQz&q3DoyKUpo=f`w7I+tBWKAmH(CZ8&sF?68Agp} zKEx{mpEER=+L-f1)d)oY2*=GG5pYY@BQ-$861@S_jd}z-889#?8PnHVF^OyMvXipm zQXw1F`ekEG2P-l~K`|&*P@LmAn*B{s7&-}x>URW1dELgqPo zda3k=?Vb!-52bK=zr!Mli-4JVmc^gL z;jvnSTAWwAAJt%POBh-R(d#yN=#J{`1fi1jNyQ2j~mQ_$ZYb_|AY?M-k{vLFEvy@tN zbEirHo-{F3N_DsfscvxmYP3d0u3xPCxaP65-sz`Aoi-uZd{~W2AC*Xdri9Kr6s1zM z8233ECpcF`*3)4!*U75SIvnEqvjSuE<;zUi!1-&x#0<9;X54#YL(%zm7zf)?cc%^2 zAKEY>g6qkZKJ;OQCymT$N@dn~)1;~%lyXB(Z9)oZ#=b(DKdg{!oGT9W6wq*<1VU34 zTs=cjuqFgyJf7wWYLp+X#@1mvv|Oact@~OuPt;*;dmZl9)nQaEGbYHhuxxrJsx!t9 z|6qo2g)#nZ8>aI(#&@wp%(ub+tqu7FHmq`Ur&0BNsmX&T^w+_rw4_i*&j&Rm=VB5Z zt}KB$$wA(nQ$JR5P>oGLX(PvCLwOZmomPUbD`D%UMhQtMrcKtN%v~KKIiC*C(qb0J z>zkEhkmb)jKtD6iyJlfndoxT$*zp3K$k<2tpK6CPx#P`;5GQs!GyGgTP%NQH_j z6=H{IQP!E~$c=OQel6a%)1iZJ40E9-Y;w=Sz1Jq}m-0HbG-JSh6Gn3_lmC_TC+GFc zoJ;48wPQh`9pN7v(qBRT^mw%|Y2Ub!S9^cjztfvaxp7|K>V$Dx2~Ho9pgz~q-I@uw z_gw|g`AQ`9<9T_k!m9ad%$&^iXOI>Zm{*y>S6i+J144AD)JKP}%%2=AYewH!nb>sC zgeqL~EjVIA7U!#4)wvGZU_;AV%v1O?{^9Q%>*Z8=tS?E<`_Y>VGCDp|PPx70l$apF zh&DwaOXAvI?SxBlMbLT^*V%a?cziGzUoWXpwyGKd^O(EZq(oj79e#2?eKw2d<$N@5 z9pJijlolt~WMUkTq4Taxp5kVv(gNpH>M%)9rL{8L8X`sCI^HO&mm-tvjY^-q5G^qFo)V4`jU#a05sv0x zHF&i?0uck4V@+dB%yIGg+ay>^8sHowq9$YCCUvbCFvNnC0t*uAGhY2@!CQl%n7Tqx zTrvrYv;KnO`X)g!ier*yTmrS*BvS0qM4InsAblSLedHSJ$8ISC;=FL`iWEN=b1l<@ zIqRu%eB)T$YP|-z91H!F8pw?rG&rHb>v5b%n}~?K#u$E}i2k`EauY=KZkCOk9#+h$ zlMR1!gLf<#E=UxwKL`prkE3avpy<9*P(0ruD4H!#qAiz`Y16h;a&MPH3pOND zkTchcDlb$Ik>mCmFMLRm!}XgCj$k=9; z&U`zMNf;Y}fIK}iq6|3nUc|v@JuD^>ZAiq8^;XPlm5nfWD`p}a3olu4ylpnRa*lX0 zSy22u!E2N*C@wq_6z_QrzdT5xr!5RLym>NR*)P%u_e8o;-#`lsvc4XEW~Me93O zsE1n6lrd0zCo7IK?s&98P{b_YaXb|iR~Y{k%j5mTxphXqNVd2X8t9Qs*+)eRu9iy6 zqeLn_P>MO*Wmv>mV|G7ptT--1g{eMJ9M|C3t%az~`&wBd9M1=9@HSF|9dD8l+k*GA zj~?fEZZbKyFYLp)_1i6k@Z5Avfvqcr;CW08>a{YV zq?-*m=0iQtNpNYq8Yi#oaPXT6Kl<2k(M3+FOPMb}7J{cjWOrS7FGbXk;;_-dMs8*EKS_9Oi@(ZfXR-(Ly|H#*Hy{)Qk0`!9yfiwLcg` zuWB(=W5Tq{oO_L~w7YU4xx8T>akUnSW6aF!b6uGurwLCSRFwI|qD6Js!|(4kI0ue! zKYBRd39UWVn0!HtO4m#{Q`U|IVFvOQ`x0K*pwi0^I zeTAcWe&*RR)n86yo;cx9t`bAmYf-v{2{kx=N9B0123SamZIo!wIr9#4dOarQARx?@ z7R3Ift`k&f8>&TzluW!}?yF4`DLu<`(1LMFjF9UvI@N^qQa1D`*@#ZH65#wqiNGT~ zZ;ee*)wkj4Vkt?SB?!H$f=gd5c3sIt+gEapvq1>Z^Wn6U%bbILcFcv#bp{P&Hh zjrfydoz-Z;CH(Z1~W&Astmq@Ogm>x9Y|~w=4@e$GLvXa;5y!4l<2ZV_j$FSDnpx z$uvUhCAo9;m_YaR6cuMnJSrbF#btdFeZ+Hg*N`o+<13m;}53kFrs%CUxEO*`6i=t2R{JVr=*IUM^i%sas zwQnb7BidY1f}TTEaChS0+dC88m)o$Sg*W9^74W#G3O#>BBP>1>uOj)J#`;mkC#*5> zd2iU0apmMp9C(|9$}1T+*K<&UZwS(OeLaIsI6TjW;!WMiBf>#4=A4LeU*%IKL@8}J z9@Bs-%N;a)w-S~b96uYG5LCyG_$M;@YpQ^YrPUac5RDHmCM5BG(*=1_r633CE~_w} z*U_vqA#F2r*1f!GMK1vzSU;%7^Ru~rCW4v!IPKv^LiYly;;X{;8Zmf(oN-)t){VM& zQQSxYJFIFvHEZF-T>OB>{C<@uZC)kdD?g_m^ZskwG1i*Tm~T@Ps<@H0$wg{BzQ+8E znYoQ+{P)iHAn}-k4%H6Dq`^8|FVA`#YfiT-x>IIT)?*@7=)mzI*~bLeNjALqkWp`c z2`U7uG5fL(o;OWsKaRQjK_2wpA>dj|HST}bVoQJ-b*I^J@n|E8$rtebg9;6%>9D%E z8J8;C;1uOW?k-N)^Enu2Pw7}|&P4P1HVm)oL&M%M2NwWzE(Pre#%Rz}|UNpG8 z6DEOqK>m9bWlh+;#D-bJlIVUvDXO&4U|~DPRm?eFm@X(JUlVD6TQBq-!1Zyk9tT{l zNZBVS!p`X_aIGimc8|dIED@8RS&+z>YTt<@YSPpjuTE$Xvx;lf##W5Y78DjSg(~&t zdYgIP2A&3tQ)eTqi=g;k$w0B`-Vg_AaCZ@NB(iJ-_Z1Z9$0gJE<6cR;14q6mDx1=+z!i$R3BozDdNpZWaWLWsV?IB(Jw# zxOXWWPgaXK!kF-)Mo`>+ucx~r^W=>*cr;CfUSfqjR!|I=rqcI4jE$M&F7Rhe$DHqY z{(GOcOQtW7!@%|U66SD(4;H-NEhwVzi=-C4kaj2>$38F)9b-kE5J90kqNias<>)w5 zgRDqBG&a`$8w-k4PRVrUvJ4c@n06NP$_*@7%v{E)+KE)^xfJ{V(!kn-@!BE_z*tpX zN>9-|Z?#)%P{WvnIgF3azY!G6w&9BU#pF#KR1q&M^M^96-@mYxR9m0}U&-sN-j_{P8Y zR98VEP7=vC#2e<1;V}0RF@1s+O|A-x6GaX5&cQhGp$6ABifF)i{E@$)7*RQ%Qe|>< zn;n6xLqxd5G7dEhilkA=^u|?&vk4mPZZ6_(t_4@O3JOmcsJ^olA*aJJll>{h7h0iv zA}F*iQfTHiITkL}z?d)MyVZi$%-cydX85y9G}C97p>k+WOfGIebpH-qGXbCo5JmkF~g?ft;SnaD_Cux>}EL?`&NE$b8^> z109fhV{t|}igOKCvJ2}Te+dfvz+`GxC`H3W4U$i=CbOS?FU=*2!Ab*7<61^}K!d_r zdc;3qZfG#i&j&qq@|9wfgx7Zh$ANOJo9uPq(c45iv{!})-8GoRf7gjhR&37{6y^IF z=oHsMpIJMSeiso?J{z~^alGnmpwqG5P@fD(!v?(WT#p_ZEK$IaLYov`%oi-gD!U$a zCt5KyNTOKuIGHv^d0|W**O$liD4$_L^mswh@)&c6UFE1aUjv0R^MB`Vq0bOO@hwVE zzVEzn>G?t=*A&rWo)yj?9jG}kiFPlQA^VaBk3B_H$+Mt11jVC^i8Qc<3|)t7@I$S~ zj9wO;Ud?s!W03}~^@6`O91%72khizsS|veIN@1XSC48_$9f36$li+aT`fRPBsPH<0 z6wf>naaDtLkJ-nRmW|#=ne!YFPf<5yc*JpLcx@3im~*>RPEd5-&-=5M3?IH|(4FhQ zp6M2BE5B5)#B&ov!$!pVXnHztwfeWX}>mdC^AT06&za*G7TD=~qVAM!@SKn*JL{-1x@ zio<;b#bQP6qqTWwIA@Dp@KPKbc%JFlCh)2%ZXw2*NU-dJlA3d4gq1buj)yNTn^FsyW z;i>!Ew5~QaaQ36>K|{+f2$-Lpi6qo9 zP-ou5jsT9c3uMquWbdL?j)N)Qu)dWds*MbJd~d>R&QpD**t}SVz$r4EIK**Z!5kCo zBXKvScx02I`g|E`ob@ag(1}v6~bR z&&wdaD1+&k9OwD_-dp7edJv9q-UD-XuqUxq1d_wp)99l?_Bi%6#%WO1s=YatXuo(_+IyLtQ)IAAU|hA z`3O|)7J-<${G7CfSkqO56MP11TnNW1_Dp8*{*SrHnh$Fh3;3KJKgu!lnFw`H_BX!J zBdnjEIb0DDr45jc(Btk5JsQUH{%5}Y8G9b@))2Ay6X*NmBANwo9{HLCmzS(tGsl0j zI&0P8dd#23-o-=_o5%8d`!j!Xm7iaef7fU|+-%HU7(_hTF2doiN9PNyF?kr^y5EAa z35?bF9JkoXJp3Eh1qNF&coOFej#*}BD^9?Q2ahc1r{dhT-h!3GvZ3eqFWJG`_DKtB z-?iZGCkqA}Ecja7ib9U18_X7r^R(c>1PksLvKGCOwP}tR1DtS>e%# zaS-!4XPMvWIm3$0vl>xkHFrAU;!jBhQhHn6ovIG;AZafjO3rISWk-5a`EhbeW*nW) ze#h1|Wt3K#Ie;Htw6>L;Dn>V^8v|wJpC_Y$u1zR-yp*L5{&~xalM@y#b<_Ke>oKfo>1d<8Lq`< zg<|F%CGI>9L19xBW+_#eX;5KB0rSbCMp8a2Jx6LpBa06TQ3wnv8zd@V1~VtQ?^d8X@NSs#N< zo0(79t%cO2MZ-xtjI5x;iCtQ(tgeN#zZNt>i!RLbPw%Y*`skp4AICn+d3u|O1@|Zh&&h@uT1@3%7muVO@JF~AyZB0I){0&VrD#*n~=}7R_-R&u1~W+E7ydl zmCX3OnmHSP8}>)r(6gEiy1q8{gykSEn>matcC;U8L)-o~Tpw#gs<#~{zvSReGp;MI zu@1k~2In9fiul-YIFM`5LpC_9HhA4)52MzGIj3@PvXKp6OERCfmbLoBcBIN}T*Krb zurLSNk8-f@9KZiW4#x`iHny|Fy3Lb57IUS71MJ;pA8@GwUUaaWj6TH3sn{uRQdIG! zI>)@IVMBj zRbQIF(1%`R%BUXmCqE~6({elWSoOSU|7Tx{8_nEadskZCPDbwA+1s#GPG58m>dySd z>z)$y-sFVCkpjwcy}OkCio-o5=zPvWBhNc%%oz4Ke3D?)6bZ(g1YG_sAdU64ydDDc zvI3?bl)%V*R@W!&F_sA^w#Nyh>Nseunf;E99hBxQLG!2rYF$Nw*@K;!1LpTUmLTD# zfMGui>DUwp-DoVpzL`A%%q_fI#-7E|N-VjiLX)>4=)-5FyIqOrBh(0Ouf`}Z6`nOy z!#-Apvw9WudsNuXe#YR%O4PllL~3$Bls%wAdK>0#OREr<6N2LfN{lP1MArQf6dT0n z=U6a^HJnR(l;}`IjXCZ3=L`Alo#wOoF$A5Lsc&U$jbUCgJrkw)`!`QaSazBHFJa7iCh$30 zZGs}hgrYUfILkV#W-ogzx|wj2pSNP72>}n7Gp)&fqVN232TV9JG7~qL*FEIIoN`4o zdQW1ljnDUf*0{Fla!_=R9bJy(pvD9nx-POIG|z@Uxi+-EYeV;aIhfzfj%mwtFl|5k zgAdv9I>UyIeD4~cxg9(BTwbzagxUsavK`K~+2_c7o>ppu#n*;nzIH6?WP{HG_Mi0R zGpDm*c2PST@VRZpuidZPU^FrhdY`$(mUisxvBsD-;iWNlk0j&Gmz!<&)N~JQv@tp` zZ;2+ba@kdZXOcWKT5PFkEZt&rz^%~Y#@w)*>Fu`d2=ot5H&zZv4(#78FL2bD2xEWW zJAv`a8i6B1o*JWS>`uQ@w~Mj+>7Ie9&9?<+M7jo6tk%cqbhfoocXW=i%&sMY&+c_P zacXx#o34%D8~cS8Zk-~W)YcuWTNWU$|%0L-P=6YdB4R0J> zBS+s!QnX|Ic$M`)|2LjUjF#e6QyHGUlVR&1DY{0=klUF3izB57@9c#(wb^GPN-_SW z4CCiAMr|v@nq-Or4a7w|tPXi4?!!^iX5`hl8HTXDQgBe`k=^k(& z%pMIoT+m=K%gm)SYOJF^2xdwXX6mGTFBc!*8jYC9SV84yDsR*CRB34Zi z5p!FQEmK8&J;5GDFaDfw_9J>T-aFjM00m>nr}y<(b5)P=Jz2{eZNPy_?0aPY&_X{E z?U{SHa3=|E-Wag2Bl9=!^r*5t3E|9{GzV;TGm3tjN2_JuJl-BhI!!%e>6)6;|{Z!#Iw(Kc$ToSJeFd39fH9 zSn+VR$P8|3(f9WaKI%S zjV@WSaI6(^Tnqm5xge{Sd(w_}a_Y6nkG>~KN%-PLFKhVFwfYiNyi-62ck`={1Px{t z#e_!!G|CX9aIF4tk$F*>8nKgE&ktctq-DR}BQ2^B`vzZY;cMeKcZK;;j!DLTW+b!z zaiKkX2-%Z1vmW<79OloDx@kvg3-=W)vZJf(TMS_RWny1fTI=Uc8_Rpspx2z&)KXgf zMou~1zSF54tdETPNw?XTFHI_-{6kKtVW` z!`;P)F7ezPpCl)1o;O`)%v(Rqm)t%Tke)sMGRBqeYYXY|O75fiAfR>!_7jAKV%S$D zj+RrRVGAX~t|@UbOot;cbr3?dSoedya`8HJe!^d~=i-+yZh(&&or{{ee}v~M+l&uS zIX;f&-U){d>v}UEz1fDOnXKQjZ*W0eHa(n^EpdS>Y5%j_K`33-YBCJ zPa4oPiJU?%2r!H(pzbdP%x3K0LsdwNc~7E+1xc09pcq!yet$suUMN1 z)uBl>9oBI!&b-an8^*dNO}NOKku&G4PLXCbUuH(DLuL$iZ^wUZrB zy0Xtc%7@$!%IVuSe>$;?eXy&&skPmmicI7_s?$ygU&j3yj9H=<^Y|t^=s}hey_>L> zIFNP539L!nRbh%s4gK+GJgcPxF(xQHqeF^b3x6Z`5N&1sB;SmVBTcwj-h|h;&4`(A zLO;sEraC$3!J6{0%pA1c%l?p1_JoW#(CPADBR0Q6x-MX@mZQg{>}6hzb=L5 z>`A7wvQ#p&KYsRRPxOkDq2mSi7OdlV-araJ^2VDN9JlvGV0;Y?pDzu2fi>8l#vJ&5 z?hlk0Q1P{h&Ri3FpD|!2^GV$bve7Mt{ny=@uUu)x)d^O}dN6kuD=2z)6BI+23JU+) z5=HM8f})9?_5INXqRdn}(;%7JbDn!RJC$%fnf4gHpdT;AxWn9g87IY&P#K(S$l;e6 zfzfj~M;z1O@@5V8E{VXH^~?`^6=Ap~q7Do=7sdQ)on+*2oxU!TJ>#hyD~EHxV1Fy# zdfmo~hPTn&!Ja|(>xC5viiNBzTp7dTVt#wZoCG@hYkoXas8eJ-ZQZM@(?sZ=>e0ZJ zb5W`R!|!v9ceY}>*@{YQt#Ie~U%xT0*9<|CJ&<{2=D-gXlPJpaTBY;4-Q1W$*GeUm zY^O+j&WfZ}BvXDHJ*9n4;vU_MCJ`G3hv#e%mf0rMv-Y51Idr+^UupM)!i5F@J5ji z;mFtX9%divLH0N;%wU~C7lHS+4d|*cp!5j#$von9;{1F2frudH=}U5+E4GJyDt$Ot z^4|Gc$XsVz)@-`)e&IcByvAOlg@U5-EkRLZvtzU)ol8tig5_i}FF8f~Ej{kXm=zkz!kD{y_|8478p5*eeo z_v$=*E}ybzBaQ3+lUnTI`l0R@_NK+@@Tf=@N)#}jk72*XB(Bd(vhQ4BMsy)-$VU+-jN37j|vZr;tgYZ-eR z`wG}}f%`d`2l>)ciLIs7*j7!6Qo%|DNOXAKh2!91EhhZ(#ZA^>_+A~RjbXoFu`EQk zGGkhQGj@D2BXAbyvQ>8Y9nHbP{W;ipg7c{VTe#|MsO08FwOaU4{7z3QXyQR5GyJH{ zZaIzGUPu)ybHA#O6Rw8~2+#@e<2o|cQ;F4#F%o*JF?cKUGdxEIhY~-Iu?Hhc3(E>E z=6&OujB{$!mt3FCV|}%$89h_E&RN2Igr6DZ7H~eDY(v!m&RdaOr_|%Tm10L+T^lq{ z{b}M@A8I&NPHQ%JQ;n-$q-xi^80T9%Sg-J%kxJ)KaN$Fuah zfVp|xTf+0zC0GTIiJZSUcloH8gSr|Dr|)XS^kS}OmlmV#TD-o+K75{^)}>+)9?SlP z;U-usm|^|IHKLapho3Vpi{L)AYrH;rHi(RYYBN4N!~BVDxcPHtmC-jrpHLD z9&}GkQ@g*S@#lIV|Q@f zu!wu+%SPbmBMsWJcKqY12n%z%%acSr9-WMhXSw%@^XG>S+34c1z|_@>rPUcPKjNIq zvG~Cw_Q+M2D31QpT{tc_f5|a%QzDgRjm>&6nJS!2qmXp|+=F-n6)7vlf?jgeZNeOW zJ1HV6%8{2Qg^}}n{ZRH*_KZN@!Emg9wh+b?u5(yh^a*A^_Z&SYT{j?qqX82yh}h|! z%|2c3YvTM>(uwD4DElkz*=WsqtJwn9yJoZYbWl*d<-Adzb-;IAM|Mm$(BSw)s@FP^ zKD|mNduKg0$mSYu1NQ{f<9@d4-dNU4hD4heK3CGf?#BK>Gy4q&u$ERBj*sPd&V1N2 zkjMJaDiNjjvflmF02O18+a;~&)RF6m%2upTWR29uz57zm@lOTCj+267I%}Y>PVriC zzE5i=Cmt?y{j@LwP9aCmK?ICtaGG?V;|Rk zA1-S!+!}$vXbogh5$Lj;`_7odPviP+MMDuE=NOQ!Y_*{5 zR_^KNxk1GVk%GB*VRLsGYhm6f zJyQl>55^mBWVpLrhN!XOSmdHX5bxvp>-e)6ShvjUslmH5to2Xjo(`U$!=Jd0OyO~{ z4$!zebMKr(!v`jRC`ddf)Rg1M4?M|>Z!Rbvp# zJW!<=R#ULFc^`IIo{vTgx;ThNnP2`(t&#fDk*WJ9($xe zWgwL~(KoML$*;VCipx=;KBe*5+za_dNHt8*N+<`%vw4 z0pi3^oSecv`3=o*-Dk(KvhL)PDWD(waY}n~F5a4nu)#Ul5hkUlMhBf*)EC?5N2AJm zj$LzeptX5WmCp`}e6ED^yJ$F4GvSh!gYv~>^pmxNj6O>EFV~`RYtENvYzPTzOlc|s zb=ZG&vXl-9?C(>&3D#w5%qGk8EH=!vNu?X+{NtwdThdt3pR8Kai_@QPRPH=TxV4tKl{agcH{aw)`t!r{z0A# z)QCHy#TBmWuB^zxy(BqZdGV93$FdKOYny!*6B;o0)-T7KdQLB(#kZ7bbu${X&v38x zt{l9W*pRx;WeumJ8e=!>u#fBcPbGPrBm602qrg4QTvsxm`ieD!Z3nnEoYH`Ly~(Gq zFO_(~IeG%ul26Lpu=sK#GWHcP^okOfhiOr>r3p*-Ft1)wMrEuHDi#~cHMtfeyK)|X zk%PYRo^;T;kb4P3u(zlVo12?3q@NAdp46ks#~DYp4nf`q{w#~Zj`Snpz;es;Jud57oVeb zn{x1Vl$5#-{Z35^g3+NF_qx2!#CFyS${PJ?ty}_$TL>mH|ND6q*T{Cxo4@>G2?B%# zO0053qtScz7nir=9ryZ0bt$A)KL=!hfEG$6KDx6;6Pt;NTx)M>A*WMK1aul7f{)eNH@7wu$?i4`jr62}asi3V zHH<96_Zbtu>0^U?XICnWaDv|tHTvnaC^E!^vrlvQGiJQ#Qau5_H9`<`Rg0AFnON~4 z2iMknQ{=}&iX5WE?Fl-ZY-&PbSw8QjJ*a9g)&+Vg(Xq7-)vf&ZhH&3H`!rh)WxnGY z_eYM^Vfzsi7H_a2rJN6Koy(d-Llu5LV?QSQY6p+7qhpMmy7Ffo6l<@NXgAmNbQy=A??GxGhCk2$Yk>nSIA?d45D491XGXz_@7hlq3=W*w7~>Y0FvUAQl_ zvTNPFwQruR2|e8cYULZ!BmcA@t*y8{N;eZ+1(dK8A; z$*^02ZG_!}&F*Aicd}W>MquCTyuXjnm5o(h;=Mi;Wd`#6)LK!9?@Oz}9?~;HfdU9cPoCQ?&!rGm^8r-2`EV|poT2V!xgFDW3atn6f$=UiB6~)|cbplES#x}0->&zkr|u8Yg#|@R2pw%s_>wYtXoT3}&`rjhaYp1Z%y8)Je4|p+?a^(b#>T`2#oUtKF>7 z-g73)zOnRNnWZC5Yu(!&7>Eo}#g~EKE4(v(R+i@YDy1Z%$(xapg#`FC; z+|i7&{Q3v0E3`M?@0Hm}8oVtZ4eK-$zWGw0p;l-&k28weR}EV}F`%y0>rt2CzKxiY z+AOC=_@Ec-NYCfY)@n@e=mM_ine^10R$;-EXebL2BbsAJT0QDO1B~+iCN()nqwui} zIfzB9A6eu7vo~J0UR9%rEgH)QnUK&s16$9#(4c6dB(SCrkJe*jwh@us7m1!OoX?Jz zhFw(H%lEz395al3&X!lG&pnnT<43D-h3nHjJP9*Lk_%|apLc*!e)Lx3_6}xF5U={T zDf1AB0d+r4ozp$$q)p^L+Q+Z|PbU86dY&@dB>#3)L0wyq3f#YWhskH~eNTOoAPXzf zQ$`JtC-pIJSK2Xy-rS!P5(PU{$QclYrZFZ|<30@zRcNcz-<{u3gZkcu88KuxxG?~SZzPZQD#@MMfA=5ttZ`<;9OG*~=ST!oN zjl#ffCZylVz)9j)FO!p{O=IS6G~oLlVZ!}~nXuQVetAoRG+scg>b@TLD<@%_yB$KE zW^3x8-R5baHS*ujoAKeh9fxmoJ#+n6u(3Bd7L7rDO*s71j#AW7hB?ggVW}FosE-Pz zpDC5+Si6=AZD_+}$@FHw)sj7Dq8a%<#QWAOw5unx_Zj7f$o0`E*Vzoq@Jw{!zAk&& zEE6hG=j%nx_o*4bcy6RLV;^-RMU;i8zuFpucAw4g_+W?sH-)zLextn1Bj?9HyZdnV zAgk%yHY>E&=kfAxvj!Ww>#?|-8C_;m&%2tvp^CXFF6zYib9G-sP1FSHj*2O?_vabK z`+}M{EpzBbCE@BtJG^-=we6iK6R&8Hqt|0Lf8OaYs88?3^L&s=`cZ>6!-tx!2jtes zMGc|;*S$%y48EYj!wGuGCvslrnC;e?p0<@n(M9le=Dl!*=R>hFnaF#=^}lkTZ0@f@ z#|7m1CYn(7nH>$5@cb;kS8fGp(6mVmCRR0b9r62e{nv{$OZ8J~)NB)jo!3nWV&54{ z%rx9-mLoUR=+RY=)Cl^s7u)gYlS132BXRd##AgRf8jyL@f1W#=i2=LJ}@n$9`tW?gOBsh?%JoHZ(V>D;I0j^iLaaaot}LoIkUc#j8MO@WqVImWpvDTm3VkuqE-)!&BymzG+8( z6bLTSqoAeT`8dlC;XeGFAakl3W&h?R$=I`3?DRFZVOGvtdJGyJ;JICzp3r&BZ!DH1 zlP@I8wC-jZyWJ?K0?iWUXO?qo$y+Q<5RWrS(t}^G9`{D4HfFj1-Y6aWo8;o*1R4ID zxjysEGB-6@UN=sb((TPMyh5VPPfnE5#AizMN|Y%&ql9PCtN2rcu}#(Z+pfY2-VN0n zsj<7W2JJrj;-!`T)1~yIHX$Z)P=jG}e9>H^#>|R-SaV5(I)NIzU#mvfIn>&(Q{z4V zp0-|t`!9U4gMaQpKAeCmRt0J3iPb<~LxcPBWqxWR4k50^K-06+ZJX@I=1|b%m zcA2=)9X%TS(nE2Tf3`CpCqmC0Ha+^CipESwG&U?`KEW70Mvv8FS#kPuePU2tsC)bo zg$dL3SkaKW$PUypwxLILtsar-(Rf6RyWu%<*0cC^J8^yU{}1OxBO^N+VFUGO+KU`U zMl>QD^6o9D$16TVG}q!c-sg)4n{k9(PwzAn-s!lnXPNPm=k!1yu5H#s+0=HoZ%STy zvKga>F^@6BjPZS#3oz8otVU)_oHe8B0De5b)|0YHm}fF!>~bUI0)3ZD=@02f9b^$R z4C9QL$b0Il-N-Y7y7r00!<;7SK9Ya~JkRIa(QUgOXTN43zcFjAX_+ux&BQ(8EV>$Y z3>0E5ywe}AU=9z@k}KTr7uIKx^UOrq51Cj@op8_2c9?ihwyl?mbG)}75;rPGtmbZ- z9d#m@b8*#l?2W$T0n(oN$by)Uxoc@-ee z`JOUrtXghG(Hr)K+N?svd3}AQ^gusZ;qVdVfjScK-b)^bYouXgjSO2HD4*$1Y$G1h z;-9*5VzF9kTkA=?OiyVYtHib%?1!Tic-+z@ElVh2eBqM40SfpiawP9Qv6j90Qsz>w z^lGbs@AZ7y_ECxCA}(U^3aq-JgwGf17Y+HME=w$TTE6T#qd=WVC5jUR|4~SEJf#=0DeLxu zW*t_rZ(d1$qd~QB;=d6X*iVOwo5G;lMNQVoP!u~Cj)!qNDA%%{KORa?pbn>qnG~22 zj$NB{c(_If%T@9L8R5)wVOHGRFg)uYhKKugIJ-O)S?_glvG=)4&a@wUg4BY{WKcz* z?SnX;_v}mftN%87``JTmxNX4C9n4lFelWj@0n1byun6oy%TYH)uD%v|j^#%U7&eoc zKV=O#IL!dfWdkl=HDF%rIMlCC4mLLyDdi2gLT}o(%FLZu5{HUr1KJTw&@y*sOSS?2 zH8Fkzk*4L(`%voNy{9#CTy zWW&34?A^y%@rKz9UT!v|CDZdt?&t3-=@|FUie-nacox8{#j50ft6A}PW;)6~p}z4V zySIZb_*j}@su(otuh72fZuYdl5`WhEQh{Y{ML6?Iic>ZhXKqbYHtnz0Vt zyyQR-dF>xr#Jj3Eux~5-%a=}^tn9?MYzOitIM}CWBZeR2=H|qo_sm;jPyb~TKaPL5 z4tAjK3J1<~bfPN%FE!bTXY4K0lui^K$A9~q*>e64OgZu%PpEA?)|0%ur{ax~gktY1~q zX4{17xa=}{sD5pElBDz(F?0X4wYI)x!{f(}j9VQAnW{?=KC=?kfgRB}%fCz|QhVL$cA zub)yc@tmGkPxkRn>J)Hhh!79%v8i$RKAKv^Nz6p~6o*1j;tS3DuF;lA$b5yy1zH_fA_Q&FVdMt*_=ALRmeQ_yjXlgMNBPtf{Ul=fS zumP_9)IE+jpjom3%R3PRsBM7Pj&uy&$_&NFR&37U9++lD!);bfDqzFG_1tq~=pRnw zei~uLf)7@#J#NLSYt&D0@4Xyh!zk`O$0aMCa*vvO+UQT<{_&*lIFcI22KxjqtJ#Jaag)E}xpCUG(o4ClB|F*{GTHjGtou;&umWbYR9KxOcceONBVm zi2HR2_vi`kt+C~qr`q3vwZv*WuXf@|Q)*9+I`H8bb4e!gYw-JKt#e|M&H<7naM;|^ z>K`qc);qY`>9q^nT8?e4A6$F!!P8G~CR(I$pH`{G-dZGjw`KR3BEh}imkHi!7}P2v z@80R#-L|)=-`sS%U|Y52srOLJmJ=FF@2F5qDYgXhHM$3ns1ns`*{H9r`h96 zSyFFo@YGfNEkjggEYn)tu@oFrDXnY#9?ST%H7#p;rw1Q(BwN~)8GqWfCP8{yljPOU zcxgaBf6XV8c%&I+8T~#1XU%eZZi1wE8pZi6LE_ueLpC-=w!co2*k(o? zO=1MGNpcpL<=J7Q^jeuLn-f#yk9U%6qj%;>Gn4djH_C5%HlHjpOS9D}^1ZK77Sv;g z6*DA8MjGW4{i`{?Ch@A|htV~OQ;hS4;-?Q@cl1R)_Aw>;X^X#8`48k`_A zMkKOETyMtT9n2`DWrpH&)@!UAO+}M1@hY=4MzD_^NN&|^!sOy+ayDkf^W)l&Wv%F9 zCiiaUd{v;1v@_Km~lcs+MICuRf-We8)e7J!*=YA&qSX@_ND7G zv5|f2z;W~@FU!Q_0-5B0=!a>>T$W5b=BCr*)-n?(_<64CcHF&5%xnp3%`kf6JhSlp zGO-%sHEmC`US!R9No&V2elK(3EchB(j~4#F^QMz*4Mq3RU)EF#lKt&{CE%2=`1jFB zW^6&+`9t0NJ7xvwa%InL1v<}Rj>pk3Y@wHag(Cuom<4f}dbBU+!|*$nHOUO>#k;b; zm>h>CJTo7VL+`c7iY6zl^j_F-vapp|T;$P85o4vk!BXJ^PHlEzfQh*FY6mv;cOvn= zhqMdzkzHPX;<3YD))iLC{Kh`=X{G|XpB3oCd#wQPoBXBBOFE@M+>tOeHbvmpL;6QX zl9O8;j-%tlaHS$^qtsYtz#4Gbo!Y$>aky88HBkxXAhMq5a@Y#PL!P64^so1|;^Z_Z zjxNeZ^FdDd`I0wU#7vXV)N1ch$)f~~+@zPst5;$*4cRG^UphMXz`3*_)$)TA9pfqkFU);J{$EH2Oc}IwveARiC~^Oc}4$9~h3DUSW96Y{YJR4d~aJ z8vn0+jtKf!F7ocnXPwCRYFcj_#$Beil3JB&W2yVx$Xwq5V)PB1n4aUnibyA75}22* zXV#U6O6Gj`lMOmwnc^ELo2?CH$1`Ti{GdMOsuBlEGjD4fdCnOMw0!M`*goOV4(f|8 zws0Ko9L|iAa9lEl!8MP1BJx95bLr{fUEQck9CQK9Nb|74y^jqymNL`(r4`wCY^cHe z^2MEO9Bt^ph&xV{=WCNQlG!wTwu|Efq(Y8b>aFpWBj?zg82n^_GEjo}9`$s0$<#GU zjOY3(wc8DcCn=e69)`lcI$#;sG3yB%^AUs`V(J>M-B9vpgEt`eeH^@9%xH{?Ls8zh zalALD6|>=1mK8D7gJcywL+p+|nYP*Z#k=b(*YVyj)Q4QA2GuiJO3@o0Fg;oRq3&zg zO|$HXNRgK8wbKv#VN6XwO!=rm+hAXGP9>*aDF!KHc?K$CaD1E|X*c!gQjL8y&zOUw z>DNnT4&q_4>-`nV09_5RbZp5kQ#h`K_ zp64Fq@%daOoq9ZfPOZuV6SJQ=qhJrQ*gP|C%w<+UmKiNlvyfxRM3wc_Ve`3Op1+50 zJdb|zdsn2^A#RvL+wl=`r4VAw)T_MmH_2jCioCyTltauU@ZFXwK01?BPUdWhTwiQ+ zYH+4@IzWBHSA{n1utK|$*m>JwN^RV_WSLw)S*kZr zk>p~j^5{&mcKw9nGAm$7G~U^W zhq#%s;*S}%d7oUqXo3$pfFJG6@XN5HSWG6mj?Y5c6y5PxZ98B;Hsk;yf*kvO)}+wWV(~&Wx>3sZA+OoTa20 z4nEJ1LgYhMXX1N&yV7CiXlznN6z{S`+WBfcpLt zLOp`nD^UJg=r0f0f2}@C-Pb8M9B-_^ig z%=}Bs#*XH!U)Pf-9nXB&7lGm^5-4j%)5m#4Ee9(G%FI+|=RRcqO>hBpXU|oZoZ#KZ z3bf4#!}3?uz;_@&9utN)55h2UHRn1s=l6cdISh;9kbfc$E8a2NeHZ`Sm9;)K20iy! zG4iYx@%wF<&VRd9i5Z9msDCfa-jvVr^{5kP8hk*Z%bcgNBtX)A17!DNmH3tOllV2w=K()0_QCej{#5o%@Wo$5&=Gm+~gADdn8#>w$*N@&T z_8_fSI$=ERB)8#&YdL+7Wi|4qpGF=#g2at85n}1*xHP4)Z2C`g%4gW*<%WLaU2=h1 z_~(1wQ1x;c!cK-WcPt#%65)8eow?9I*^e4HAA=Z9gGO;^#Tw{~&4AmL9rK;|Y$oNHIEdymQSqfsS;z((R(C&S9o-G&L&SxPAr_<1ttfZcfMbD9*0v<3#(t4xG)-#@^rA(78LX zpnQrnW~NF(_B+i!n&r^=REc{??H)5Aa?{DT_S9ffDmB%InZ?4KgsKzBqqNoIBz1$m zCdJ^GgIH~IYQ6t9A*@{zvbUHqjy3q!-{gdNf9UH|dp4im9itsrt#+(YtwaV z2k)9?^c0?bG2|0@Ps9vVY6UY;a?vperEFO&S$Jw?h)GfU?lDe_p&e8wi!y_fLC zb*`bnA8K^YWbRFI=DHYS;9ffh_p+HQ%zESa2YS~&vd=of{Gy*`oS8?jz#(SoPv zcqaTxWZ~o4Oln9nu`Jt;iV?)fjeMU*DztOIkjrbP)SjKE&^}-d;!!9h62s4{-oci9)WmTS;(mmZyV$DoKl1|MI?piMF6o}8nf zW1|^6Ba*Ph$hxBwy&b{KT5&RO^at}k<6e|%+5PY)?MnKkNq9kvl8YO~aezz6h>CV7adu@XuB=(F!ZjdTh1?j}M25ky zFl+37R;UWmBX0JS?N9UMz|c@gngM^$w_<2D>c!X#+TZ+<)?a#~mLnEZUJ*;$l#O!l zJ>)fW%1T@f!SnCTechXmnx!3R8|^L&O6ADX<6)>YFBZ$A({cP(HX^or%BC^-5;u>2 z<7UL0&sp(!3BOKVZ}B;oCu3&o@Qrxe)^AoEzfBDHiLWfCuIlOne*GD-ICPSkw)d%b zJLoBS8}gY$ABvFD^gSK7!gDMA>>oVkK<#`vQ$&YZr(>~hGjZe14isssmg3>LQjD1W z&8@MxGLe|rUe4@!QCDVM`YkP*ha>a@{lyCU>fh0aRM10ecFvV%<`Crb3H@wn^_Yc5*d*v_W2>O4Wr(tB(b*|>_2|^N)h6xUt^ig z&%P?3-?yHMzIkY*f1na6g+g(OXYo64dh{C+U!EHv>$D0SEJNIrSfRZXvGF3zd)`ma zTtL258xaa~QD)YENkO+NV#A1rmtgO-gEW6JUwXf^`y`e=E{}O;qt$+(3Z2J<3(b8oFSArPl18SVHnnuwa%Y(EH`9h5&OB? z5iXgTPW)73fcvv_EbYqYY{k5b0M;+OdsqKsz##UC=amlT+-PK7&L6q_JRHZy#G!&S z9jcRDS7YnQ)MtMrH-a+(co#M*cLsM0FfW=sQol~WrN)XdRPW36M*ZoQD%n`|xQ6)O zaEURD+Wb&@1E~9ZT#7xOvaZ}FFLdEC^B;B_@Q`==Top3~j(CaN5Cz`#)gieKvmH8G zQHr{)+9T^r-Cy}~erp(RM6x!RX~lt3e4fqpn4Ha*=GNZmH=H@jrRf9d^Yn+{A$(80?LokLo@8A#{8qw>r>5h-=JM5AP!~;&9h@}^d@5@sMl7?y|g!}7c z1sw)8;OoQM;0k-k@<%;oH}RHsX(6~BM~u2N_w_CMRQ7txf0@-a=j*WkW-LxDq7KfF z`Iz^;WLixH+!}>qaW4aQF63+nVg^e_F*o5{uADW|4>FOtu9J!R?r>n?bx$#F%9SzB z5KJTnzNaO1&}XSLec&St)#TH9QfKGGybE1AyvK0C9Qm z#>F~*QpPV|!aGx^Ol*AT9?sy}LvF-TTf$qoq*Xy3^u)yrY$vxf)Pcs-$-Z`1z`bq= z%J7`I&iZU)ayH7ItReT;=1I$DI&5xhz?dRdto+JZ83WZ)_hG&iTq9K@vyjq{vRJ%Q%*ttnb{;&c;1E*k1t0L|JqvOm76R6KSHqe zt^rX|%pKtRA9~PR{+Y@3Nv!Hm73!A)U_<-hOWE1f&5(QL3DcW0U~>J|BG59=D9@NV;NE9Zp(yLB?!7S#cwPl7+Fnjo^MtSB*?7AxR4GWuL zy+nPYRiVwR6fY^mRB#LD^8^!@c*Hy))*~TZlcZa=H&$+pLa#PvJRWPuJ?bTAO-YbV zZYu0)!o0kx%q}WNUpaf=Z%q?rQ6^_vj?&{q6#LUJ%o_4y{@ROulFeBJ{`BA{ji&D4 z5dXad^ULTRxn}f1+2_p5TWG@SqjoH&kJCl%N3@EXiivv6Xl_QKiOfTssnCw8W0dM` z>1FM%M{a}($7+%1XB~As)-3C(BYV-282LT=SEKEiO+DR$%|VPpI~tzu7pXdb@oBV zBx2>ms9%^*y-AyRS*K-PApSHtU*EVN<<>)Bnd^Td#C+d%= zUn|E9@cALE+x})QRjvtlJ7%Cby&4Z~%>24T4=VeBlts*nBA%UTP-qhmF|(_J3QbRP zPSYzBrsZWoz0-xE4UF=!pavbsM*|g;@a$P8svUJ<+^v1`CD#u(=IHT^_|Dc|)KKhm z;a(MLXPz?q+#Zd;*jv2M$-pW<7v{8%m*COVg;k>t^qL7%b~D$KI;P(p_lbFp2DNH( z-pF?9r_wW!Nd0VDtWkDcQDJ9_9^0rBw5=xYK1QJ}$eAJc%cwbPjl9BgW~HCCqY>Yi znOrA^k}8z07mdwLsK-pSBlNQie?pB?;*Jmg1VuqhU0Vxc^Q!GGxF1fG&9hV}V%KA6 zFX~dM1JRyzA!k>D?4iD|>Rvs5M4FKGE&~gwU;EI~C`tV|bMkg-iT-4|5;&_GVW3aD}##d7lJRr#A0tG)ztt zTF2V4-iPbJCPO!UF|VRLcup_zCX*JlA@Sby!2m2=c^FT<>giPRA% zX274dw`wQ#aZQ=G7Rz;#Lfs!Rp7IM_SitA;kMu#aEzC;GBd^km97iRE_SVlt8U0#? zSFh*dS!Z%BTbbp+_0zAKNnS?#Fo$w3<~KGWcoO|f^xDqm`nkrO4$t?|__~GM&Q|;X za$0Y1-7Cv-RY;X+Tp<_px(M+luID~&jZ$)v8v6^=d-t!2S-f^Uq2CC5;wAYBHB&st zzGibj#@lgvAp5=ciL#13+9c|!&lfXeNI%XJxI!#5D_)Af_90%y^WiD=l^v+pW?kQ# zz4F%P%uiHsee&mBMU1W5D}`2b(j>L^@!V*`eN9X^yrmtNJ1Dfpa#E#V8_q&2LhTga zufpBg1Alj66m@xB8~Gq&aTL~2Kiju4UxzrJlPk=uKRHw9bredSFmXm7^U=5-LWjqT zVt@u$?@+(2Gof6a4CvJKY*$K@!f$-IAE{&AXF}QIe0|uH#11q{lZEW#mq%l7xEXF! zIirR8?!MF`KYOggpmv-O^vHx+Ettp8btU}xZ(JugcSNJ!CKEd9Ie#{gxaF02xx1PA z?$*&Lbkl^-I-c`|724pQd*$j}uAlaL6nA5u9P!3QHK;eNpD2Hpdn1tjUSqDGIW4G1 z=Ig)WSAvu(!EC+CoV{aYo?~VP993O-);L~*R6bbRfj)LSc{)D7=j(jjpkC6#^SO8{ zJ#M~azQ_t+@%6uKf|dKRI@jC( ztDdn>=;`2$ibGDX%+0Wz{I{!Rb410E5r|9TT=SvcyHrP{_u zryA`z-0H{dVyzDq85vym*Lus8;6s+srv*=+y5W5~r`q4G>@TiZRNl4I99~7!&fS|A zJc{dVO3P%ae90_GiI?(w66NJplawhyZrYe62dbIn3+L=K>y;$t8%C+}Bt=}4O;Tj8 zS$eGU&1W=UYg`{+XOMsG0A|d$r5|oB)5N><=E?ZIk(;LEWLb!XXrR$RW3c2@qQZYLC$(QIpsCfAP(jXK@D;257doAk5#9mkzAU0eJhqaGqL3 zsF<^JhnzJ(_hd!Z73s|AO(oCm;mFB%MY65c* z?o-eF-H!4N>_~2x30Eldb*MjVLi|HP{J!iUW^80;V#H*g>j!yf@jhPGh+MY9j!m`i zVNSa&bO^CyPq$2LnnmpII?t1Z{IkQ3Vi*SJZJDU@R00pL1OL3d3Mx8 zmRsO2C5zXW=D$2-Zq2$fw6DKBJE)QYV>HrYgolj2Qb+u3?$R;VU*^_oBpts7%Gfzx z()68|T$|}BJ-QP+S15qCE~z-uCAt5SYh@;5i+wJcmE)3=Nz_cu{Uas%B9|a2b$(N1Yb7kaaa-^KE@M8B5v3e_T;7hLbDXl=}JOy47 zfA(Zg)i=r|SA*zn4OXJ^d4B)J3M4oEBX?WnNe=te3CvEMxmmD%if_L3uR5{^IBLU4RnDE#?(dx*8f zq|j$pIuw=0>yR&;UEv5pk1g~HPT}mPOdaOd2*d4H)IClM#oGJqmEW;%I?Oq_bLd$k zr=qSFhtu7ujam_l3x^CS4bDJ_X6|A>y_MI#W{KrGWabQiMY6v!(qq~r!iu5njV6s}CSy)IG4*uxTV};^ea|Jpxk8zcQvy2>YXMcP3c{avR zVdlaE2j;Y=UU7>9$3JCrUKZzFRiy4Qin$pd-lKqq9?f+Q;9NFwbtlZZ)L>a1u$`q| zaTd8}FXlyUaG*VBn|ul)M-@m-)nNy&hdc0_eX9@g{&`Iu=s(Yar&}GE&YXTr0gVK_ zt}p&$RPv{)kDSo^NZVYER6FY@Pa4z}Be@Y*DV3C}?=AiF0|hTMGN87%SeALnlotM? z9_uYt26L9BkFPA<;wg)kxJ%AtAGtSx8pqv@By@ncJe{YO-$!doV0lkz*~D9}3{uP7 zjs9Zu^OEY*>PvLETK4ZFR&Z5;i;WbV$B`$M9e?Com>cQ`a83vReZ(&2BW2{ttJVr^ zE1oY?xtH2@cgav{6sIyX5D>+yo8x&eJfAJfwq-I9eU=P;BOWj<;*+Ro@kY`rSg2 z`CA9io18fvti!mBP&_FbibKUC5YUDHJ~0GALv;x7(_!=q;#=>jp)AP#_KsL4ap0i7 z%z>;!tieM6@Gt|iB8Zz5-T+5`=922;aD)46|5@r9xervw$k(kS{&U=bx}&Hi*2cj) zkn=8@8t{XA^f9raL7faZaWxj*>lyIiTr3*YU>*nm@An#JtcGyzm^Z(Nj#|k91`I1i z9b*`^8B?hxZb_c&EA=dm4Cq4*O_ym_>UnI;-?k!@8B`yqrepOzD>}8}><*O`GjvuQ z4P+K0F_j5Lx$lNsvEv*0r^8lU3r@$`p*HI6IXBwIeeyURZ=PE5*SB<(e#d>A&bc`J z+>XDj=-!WW@+PID!HINCpGzFOCV90ZHVpk~#fez@re|?aZgQY9@zQ^*anJniKstXn z7>L&dIB|DdHk_%%{wxmM{X-q%nQWYNIPm4BgBY&^y57t(nk7 z*Xdv>U;Uw_(%e3la^q?S&stkKt;VNSr|XREE$ z(bQ67Q8~-~$EM)x3#+8vsB_V>(|9BJ^D5t9@8wrdEZhFrGWLp(rA_|}mg#>VY}KYh zx8N!h@3pEnqIFvH_BoaczauPBktHmx21HoK54y_8jGvYo!4q3vEjj(f$q!#GjS@}r zh5Sc!+e9h|bm zd-!609deBcYG{Y5k=ISdj6G&}J6SJMAJVZUJ#AiUoKULqHC=^GyXcSM{EH3j^}J0Q zoXb;V?GhivrTM_?AoUyW)O5@wesO|WQJjicCbJ-yQA=sjW96|J*r-+b%v!NVb3Gac zMZ@ig9{ze}Sbd2`hrnnQzpF?65Mmkg$W@hz!K|xMxKfxpnT>i>b8-%K2lKaGFC%KtxOM#=9cY%6ER ziN(x$cJ`Bvkq+eojF<;sZk8%oRY(wnUG9PVqZHVn($*9+0o-J^SxOoHlAZg zEvp?v3T2{hiA?Nf4VpSE6T66W;JF<=Ggv$FExzTX=9LR7X`@0 zm;TI^Du_}m6xbZ7z!qj`&wZ>w3^gLJT5&iJ_GF&jhje5%W=4_1hDc)lk$0JQObyy~pAUFflyf_GI&me! zL2RX=Ox)@(@5u{2{^=*%TKLJ_c0MxXOrE$!6hNItZuq$(U*07vP`Ma05)XzmCng-7 z{^+o2QW*Ll2*a4c%;ex%+&wrBA6N64A`KYc+yHM6p7q%_c=Nn9Eg&!Q-HL?yXK?Kj zXHai;!go98Lsg~Ln$KZ+PfjV#iKO}Dp?-Nw_1pe3ZvtmZO>H3gW7P7tBr~KsC{UQ0 zCtZ0DUS=k;UnS~Pp6JkM9`7^eZQbn|2ImLfQ}Qy(O z)+Oc-_M~3VXodTebcF7s9;D3~6#nZ2_D~mBpSsVwC8z~iMt#b12Le8MOHY@VY#-q- z_m=xf_7{zebp*)oCQ1xFPVYjL8&FLNY3v4tn;ZJ_^%*lc98Z>#*VquoS(IT&_N8v` zAT|9(;?V6AIikk~jN|WD?oxX%)Ks2lJ(ohhA=ZYz)DK=~Z5P&wdW(b10Nc-*;H{k) zaf5osNb)Izn@CUhK$$IZ#nDDKUy$i5q&yN%@)@ylKsOlq-Dk`I;}@USUuFN5%OhoPV%Tk5W^aYu7pkZp8oA zGkL$Xb~j5$>MmxKW=&5Rw>ldvx?3yR{L1@$Ns zhPRn`yD^;2bCM;y8g-w?sFx{lK&qVQ zT{zB{xr>}{)J%har)W^UJbj$J>x!px?&BPKafy>hjEcc8HSwygdRPycP`N)}lit*; z4DbteCDkQoG*`Alia(v^CYCP&P2){A*$Zu_NeA7YKvo{rk(hp)ZWIP#PD z@d;nteeZ{aRrHKLqJHN)^OAX&E;*&ggiA5hsU^WmT=K#|&J694gxi`V{QH64PVxgy z-|-m^Q&;~o6L*GC^GSV(atFURwXm7p>0n-=5`iwTe~I6kboo^ z=a($aJ{Tq8JawKa8eA$uy^JU4a;LI(2xH#Xcs;<{VAN7Q+RbA2=r=v~YnkEEDhYRv zGMjM%v1;Nh0UgY^UN8ysPf*)*kZXrJ)byKntZGH?=iix}O`_0F;F=kuQ)-pO*{AZg z>9Udfrbb@U{gW5D;l{FOn!of6R>?AQjKkdMpFCa=4Hvm2u(}eHiYe*iQzE?$^@AI9 z2#yNFttnx|sW|JtS{Oe6LvD8j=Os=yAaH9OJoA`!!+YZp&%tl=t?=c!_^s3#H1M!t z@I4#$4B;$Z=Kb}o&kV#6C$^iN@XXCdy;P0djn~MD!a>qJvXR`r)IhFLL%60lXIA!f z$;1!^-k%_@(at45ausOf3P)PB4sUrT7E0G)=ocNbsUd9sgr29p%!hv$3tMXgjvq2G zqaqIafmT!xw;|}J6$3g^``(To!5U|<{~ERCiyauZ#)%))ci;2>fMz_ScmMJiMUe*5 z(uvgdr(El3{p3zQxO>38GYy8~~TIk=FyRBM!2dRc+IJ=6*^>knPSG4edKeaUZs zHR$jp!+;f~+3(m5c+Q?ExlJ4~IrdS(Htg=ga~U?Y+Ga(Ci@eVQIJ4n0XWxZ!rt>5x zmTl(T%cV{{EKJ?`jRsOp=_^Yj8Zc)$K-}YkWa--gxk8^phPx62uJAQkszm)uO5|7- zs5v77|MKpt^N{|xEZ*@edDk<$YvPJH3|!58n;yhVyyM_sYXfe2Y{1$wHu&}7>2b_Y4hnO9Tkwt_tC78$ z0`U6fhVA`wWsOzIxwvkq?ctJJT_WIBoY~Zmbo9LG_+CcfR3*M%tbc;?nAem*O~)SQ z+KW}V?r{a~Vv8E-a7vJC@TI8eRj2M95U+g+R}#GYsNXJQl`{G@mP z0QoeqvD9UT<*9Vep8lqi8w*&A{o;G1;S7_LoRM(PCEL>#_}7y-({~+qRqTtSX1-sS zId7zq4v$a7q51~uhsf0@w%LGAe6Osl<4`V@IhxetHtuV~#7WHd8e)UJsf}1L^ZAQ@ zKqBvWtB(_F3exY{p7RKoCrQsZ>dpHckod8wqWzpGeOjkT&089bIix|q8_d?IPtD#Z zHBg8+HTU*CBeP33QHvi+ogB}j%#%D9EoQt>GT*!yXA$PnXMTx3^eW7VC7#*-KDB7a ziGOnMFUn%JuRH5xa?VK7&P1xjq5weF%Q$jc!B-JAm*-LH$#_8 zt@+#}ESf{@po@8X8fNB>Cr7+76U}*7RC424xP@5|M&=8z=lnHlEEk+6k9e2bv@B}V zID>n~O_MAc!Z}XNXp}=Ka)+5Roos5%U+M>Ejt1R2Q$JXhnEFTN5N1Z>RKaMJtQLbs zo-tTilR1q&^*Ftf**3432TweC`7QeG6OwS@uOw8?&BT_c%=a6S31bgx_c~{xgenv7 zcqaFvUN4Qlg+q;aF7iy=yIP^$m7FYHW+Zc#;C?yu(Ihu^BuSPzSyFAj_*jO0+CJ7D zi!`9O7Jb>< zD|dsLCw!keLF#T2UT5QbO)ojzfqK1Wq3Cj*o}@_PLY~=Z8tW~SYyFXH8$7MiiW@vMq)BsiOwGvRL7EpBRmgzbsGs zBN^92q1#J+pNAD|Ts$N8SLa-b9BDm7hZn5bPj;hDuz~}{!|KSV?=ItflD1o+ zzRPp8VSOt$7l`k3T<&8T#uCADC{W%t@%>FawzWb zj&E#8$56g6`V>V^dA0` zeWjJROR_pLuk8%`ZaaI)OAcfVV}8FjN4}Gj*f^0`rmq!t{=E7?Pgy+8C3RCnnc2wR zW?ni1r}OzU)G}dGzU<=rvb{C=2I|yO*<-~#@E1L~n@ykT|DaASlHYgZe?M<~m5j>F zlfm6WFq!#!x5xzyWIr~1ho^)wL!wAl2ux$CJFCw=j`#1K7HT=OGDrIE48^Wv1{j-J zG0u>U8w=`*W{pe6aa}EM9gCIysR#T?zw~;wd zd5t(5#=V|gsG2LoRu5SUglFSUa$Q-k z&6Q=*p*WC6j)nc;*&*3@YW0<}2I>ua^@gq^ed}B&_DFga`npT4qPg<&Z|YrtWu zeHO$*3w`#H+{{1ns4IW2=JaB4{k$c9`aZR`{Ho7+mn5QRm8(vr$e!TwTG{_l)A{?IF{Mdh{f%boD0P7+c2u0EFY6A z)3$`7wY%Yexvphq5(A#(Ek{1)$$~Lq*w3FgOlL*8ZtrpLL0!4PeY%Quq~{*yY!0(x ztdsiXNN)*#>5@-HIUm`VIgh8Us2b?NDekY0e4dIq%#D3b48W9*bspI`J&ZN<>U^n0 z-T)O?d$wc>Lv}W1p7jtV`3j9M^{rD`pYKaY(>I(8)UJ+9oRKSuA30wkpZdNtX*ff? zde8zdF;fqCS(qadPmJD+oYPctM$|Q5OI2WyS15*Tj)jqY)-qzy#s15on8H~OJwoxL zya5Bkt(fw6Hn|~hnK#NMkvSpopFj>EF&zc&WW(CcQ_Oq+NGs+qOpY-id?9mG#}MBx z;v?>VawUFdC?00<^6Y*~j5D@#v*XX-BJ=ElWSRZG6Zjo2At-48&i|BJHFMEdwiV}9`?cJ^~^XaYK7~C1OFte zWrOpl{7MVOJcR+Cb*zYZL7j4NU2*u6JAEF4E!C*YEr!iUlskC`J5{)LUb_RVU|N_8?L@2S5Ple zI&ASlSNCY@1E^~YWnMD%GRw#BlPP;tC`nBC^)vG1Ui4Sjqdv~DPoC9Rq1Qa(wXAto zf6TzjUJ7jidKrD0s~D6_ofqqmCnf0FzU{(@-NY?6s4?k$6h>4}LU=3Y&`~#6b7i9J z{N;nwv!hUdv=Nnta9%Kb!&;$cIX%W3joRqRvvLkWIqKSmu|C0Gaqd>3jyVd)Y$jZ< zO@AZxL^CsuvSyYKzPw^?+68(w-`Ej#IUfzuiQl(jPTYGvI;zd6+a&|%D%00ToZdi8 zB8;`bP4=!ysTn9xRG|$^Is#gZK zEps8pmMG);tMP9adNddR=drgVsJlXYr=n5xPubfSkHJztf7e$TXg)!q^`&kuU?j7t zD(dlJzlnDV^JSG&rE{nW+0m_Qw+ zE(XQI>CxXxk0JG>1!tN>(_D?Q9reg7L!HqS>iE)Jxb)sAGwP{PXmm8zyNF$N$Y54A zJvc3rMAcV~CxxT2lJ8^ta68^5x#01MKkt1X)OXPL8UAFS9O&+Yzzb1`szfa80dqnl7223w zK0o!jtD~dg_+vsZu7}yIMT=#|%ZD5vY@_bQtuJ%AhEey*{$@fS@Tu3r ziOS?$5bF4lAcGsI5tsP?k@nS5ZEoAQNvXTLAVrb@73wYRnyI@$fO<=N>h1=Fx+_w5 zBm#9O5U9Hms8F}lK;4VIdGBw$_r`etzB>k^=LSeZzWwdJ)?8CUaf>}v{ASjdvzc=p z7cafLyJIZpBzYT+2=b(#AbDOck+EW&=!O%EsjsbR!lla8ijC#<3OOKO$fHco3B|(Y z#H40%{f8;E4=%*Xt9vR;xl4ZB7J7nJBIdn7_jCB!_;Bi|L=ZkUUwX zkva(v_>eDLsS5Q)lWmxrLBGhj{W6^E*{5R|n)7vsFC-t3yx<$=SXp05jp_Cf zJue-LE*GL#>Otuk#TgWPpiX<}A5nyUg^>klt}@A*01x^*g`rt7os=)Miz%_Fyo;f4Ps5$GTVkx6&2cluNY)~ zt{PT7^-Y}rG%rYpofz5hs5qJ3Mumn)nRg#e-$@7Zb#4~IG(AS1Tp?!pA(Wm3MqItl z-0-sGrPhj-Pj^(<8L!7k^64h=zSFUf8;Kaf3=PJfPw{g8gt~6Bf@Q1{tl;9#+T62G(%JaE5t7)Ei%cCi8d6SaJw#(0@%r_b+cdgHk> zpM4$kqsjBF&gZZCh~9b~!mvz5e-cmTCX`lah2f(|MMBM7Phst=`zl@%8JaS zj6^3(?-LK&wSU~xGUU=BU!6W7sr-W9mY~RimWFk&`+lrZKY68YMAF{THp{{y|0ZR2 z?$mZ+>4la{chW5<%O7a}`+lb7Rmpef7Jo06{A%?|%hWf;+OIoO#Ztfh#-zc2KUm(T zeYGTJQ4gN+xlmN9yNBvC_Y%S!(jWd%{eG@imNcal1(t%r?>5 zFJ9(vBF}v&XWT6ea_4Kj^b6tr_KBXiX|a;aGcv3~jASmOuj3wrgwHU@h2us!aw=AK z4Pd5V1*44Js(~x_otE@ozQ0P1>NPa5s>v(u;|b$-dNG1oRg1}AoK6qj0&)|ZF)z@E zKD#`7gD>#Dvk^}Y^}r5#&i-^DC$T3rke|s}+(E8>kOpDA*Ivz`=MMdOKKCV$UZ+8E z-mk73=-*g^{Kg~9oPOeo(YrMG_a*C*iD3xYM2zaCo_;&@RxQnWGS4vYXg!oa>A_k{ z56`#s*m2h5dL=!1P+|B`QIE98p%``{47pBv{HPR;0w-o{kdHW}kshNr5Z_+FS@xVz z>X<{}QH)skV?D8ya9mkOjc8C9HZRko25X*g#ODv3U}m*T7&>@x?;yT%^ST)a!p(4d zVZ@dx^u$?WgnLC3f->n}y~u=RW+RrW%}8#@d_m$M9fQqCy~_;hIVQa6!;Jb?oMZ3e ztebVytyAPEcIWrFm!CXkLNb5eV;p&rZTWN2FdMa zJLGJJS8xVgezKO@OFwESa<13fP^ToZvAdifbH+62cLq*rZOG^S`I~!2-y@muq24yV zQwElBj^K1L6X%Jcg^&~JXkjhFb8;7Js@x|wL=WNInvXp%%lxGZ8HnD*z3VyokvmvZ z9LM0BBxk<&FUZQE`D)mF0C6l_Q0VDaCu25Pk71)zh zAf1_wd#*hF;(8Uxp03njO)8Z1NCozT$vRZ4+eBc7}*tHgjE z`O^MWp#-&~4y%O%*NZ6VZBiiL+9?sapIj~CyKWu|45`g|0X1K7#h5MkvOvP=Be!t4 z0xlgDSeVRNxFa9S^hdAdoTvJ-54_`t=;QwA97K(qRfnvjoN+42XWUG0w-|q%=|dkl z_BRQC{INw9z?>R?be}=aRDVCr*~koP3-h9O2H@&hdi4i0Yub%IK^4i%Ivm zB(f?;VZplyc+RGGTr&Ib<@|m2&)p;nKb^?m>JovVYEg)p!nr_s>gHfS%Ck4sxh`Fz^qRmX^)jp@*t~q%S3hEe_=3wYVJF*IyO^{75h%7!y?6uez8;Jew z$;P&HJNl_|FqgmAOr4Fy_u07cm)|>J$H<%6a8YQ888?y=i7J^tL@jfBc*&DdF5;nV zD$}nulzVr`<#lA%GqyM4xYkvAK2u2;^P{sb zxXSiYE^;ujsjOVtyB60=_9OY=R%bM`2(ZXENw{wz!%~H-#c%Rze7Krct0ttRnAk7x$$+cev^671% zY+R?rpjQPlQO6m}LIr%26fh1fkhj|un8^D{(JKJIj|bojHHyXW1fXP)4v8ZIunGQ{ z)WaVmeRU|Z${(di^06w+i{WF>#s@H;YQTRzr2_Wp;8fEe1AY8apSa1tXsC%45k5vc0wuKoh`NUm`p%m6(ZnQQUKE!et z^Pcf^j70mR?B82a%Q-I!x!%MQiQ76|CGVwuB(|O>wo;ECB=4Ca7DR5tFlJJmBj5L1 zB!c<%dltP=|D_jWF>-{5ko!0-5|~KbqFogJ)pHg(h@Kb;^ustyj$=pac!hlAIlMP} z@G;_S6UV0_ZFwqZ_SDZSQ&Hj*^CE~*g_Y)7C!ggYJx+=f8$7s>-Xd8ks8cQ#7fX`I zQDBAFJuA|WrDDl3em~g?3`s>XM=P@GlNZyQcwZmR@Q4?UqjtDFRgJeUrC>kr%@>^U z%_dIh#~Iek7vxTsOu>NVydP&Udn}F`R~z{Wej;`{!lOS?&Rms-{>m}&WQ`&V1ij+kUB*PK%0J9w>E58%8Baz$vq|Z)TJODe*F@NP^7R zL~S4Ivo<<{3k`BFMT z6v1Zc??G=ybDUgQl|W6QS&lle2G5U`lw)yHE1&wYal{bz#))6E1euyn-^L|IF(eq} z#G_c^!5;X1fwMASdTwX4_B%k#!jCzjuQ)TSqDDg(HOhFaVCVOoXAyU?s8D988eKkX zQ0uxH<)^ARYw#eqUWIol)VP$T7Z&k{rQV!L{_6?#W;N1RYjAIYhWvOH&M)NGIt_*| z_QVS(4f)GnC{@oB&8efw=f6eRPt3YY53eSAYW_lq(Xt*SmSml$M|0MSk(a^{Uzc8r zC8>3ZptmAtW-ZOk#&qC(@jP`e)Wa?2?`rt-M_ZB4Q#Kquy_g+f3q@;U7FUUfseA7odJO#(isZa-M6rKs!yY|hZzz604#V!_Cd}qc?#BZI?rtNl#G0>1 zJiWDJsdX)5hUJVArnZ->n=tab5iz&e*A6$L z*gkqTR$?zj+-dC{YU}=`pUYPxvNjp9ygB`*nv)+nlyk^56MDKB@w^E2q`Qqc#@C8g z5V!Fom*#l}ihpI6W(@N*I?&IXe8fT9nQM1A16NqvZ8*p}l0BbYn}KJgGBJ;jB@Sjy zxSM&hi!*U>mJJQtW?L9J; zO8zF^V585soqWg5w*SLt-0a*~jO&=qo8~SjS81dLxrDbk<8mpjM4dnd`h_SkG`CR7 zv;OjV!hGfUK=ip5fQ~f>p@w@9o@WN)^^QP#Ek-eOjeB1<{TYc@7v&87YjbkOf3k*{ zlL~X6RP_48nNLHW@sEi?tFlpPbq>;3@=WHLedjzq2z+x8V!-(5AZsJ#&Gp_?-*ftO=Ytzeja}=fy zi^AzGQLHVZi0yF?e@AZl0oE3$xi8jC!>7Ymq`9Y}OdWbhbKiUXhV!)6InWXxkFC!7 zU<|!vQ=7={d~eBcQAuU;2m5qU%dbh!@^Fw6qcZYjB+c)_1$3la0fH@XigMbex!chF%@q(gEM8Ok~dFo$PLy@ zZp5rFvhKJ{PB?3tiX(C`s0DMdi+{j^>OSK8Q6nF}X{0SPqQ(V#${CeLes@>k&3yVM zFIJ-G>LLh_D3BV{ieT!RKosrG45l9e7)Rf&J1qmLsU_d?F}GPAi|I3jW zVdB|$i}hS1aveNVvF>atM&$5JnMG`UI{Az5=-XS!4AB?ai1sEnpFv-TJB{RLq?`13 z>LtUkwve%op0fD8r#M|Jlol=M5lIe)jl7U~2@d$#NP#Eefmp2%z*yG4l{N-plR5x< z4+SEgHR;qR}>o(*xF;ompQx(kpuu`LCVG zCvqc4h1crUJDxRDG;-sim+T+wAvagK$>c98@%Y(ThO$R+%2#5=a|Jy0N(9@K7`Z@+ zedhw;dy*bkr-JZrgMs+HjC0pgIyB}CF?eefZgLGZ=@x}gzLBV#5QT}0Q_+eX&*o23 zQH`I?kiltqTa7jHnrz%F!+a|>J&ZX=IY*w;zJ2sTsbP}S^slSkJYKrHnWe}JgD8nB z)NHQ7OYXUqlF2vk>`6~?Z)huM;8Cc@r!aE9bII=xq`%dgaEvO#d;;!48@c}^wlHJk zUV6!%p#SR*;)Ud2Eb+?3(mBLsT4!Jy@A)@xnHfxuUeoWy@5wV5--~ksYM8qbFMaCD z*KZgv-Dby&+Se#W4;UppJ6^u`@Pvzn8phsU_@HfsSqGTy+){;RzTtQr9ge5d=}WXZ z47Q%kRcN4xGkf973rz5{(l?3yZ{9ENncPD|8*p#)WiLBC6E*nWTK6M2C5=5Vu`|m) zg|;Ozx^;D#14AtN^Ct2vi_mLur&)%O>lx&nAg3-fM`gZID!G$S5TM57isa&_d&2RB z26r4aP;k$mF+Utb?$MudgC5mdhocwqg~1cZIX`T~fy4A1{A0$)T4wzIX@cuaa=giL zSe9%eU{ds5;=S9vhXO=ftz%B1gVG2Uc;@I5yvx`zE&PX!*tDbe7p0?B_BNdKHC>l1Vc z$_qpTatOmz1IhUgfIf^l*!huoKA(QIwWCm)=hjYs9Un|T_=~9+$^E$wJz=*vq+v`m z_RSxdJAEM=<#qHPd`0aM_v&@5(OnGmM!f7Tt6dsN`R<;Qo9-gF?l+Pa``zVNav?PW zg>s&}y{*JsYSmKWN^qgPcMHVgvjOO_mp+j{1IRZB!1!-|2qu3qn`hX-B=$8AqwuXN z_vg`(_|lJ`N8eQJV6W2UBE6!7y+tQ#1#0AA$TRu@mB_&xZ4Npf&&J*y?$0;9#rGd? z=|JDXUF4shF=_-c9#UMVL^tls-oJ`qNi6Xn_LnJ}c%~KT;CxSqokN1Km^m5?%LQV^ zd1mPqaDV2$+&zLGSpB0ghv)s1_B`kRNuw4a6;D}fj6KY=b!{r1g;FC{B?nH$$Z2ew zgUs2?YPe1=!`2)u+TkWk70fJ&R*U=TmXi8jEnA`+OVfJPz}};`r?V0{(F*n}_MeYf_gthl;0^1bH<1`$k3Nn4s9|7^;r#h&DF4}t z3*-$hKE$=t-imp|7OL>P>P9`+RweTodA^srN1vWI?oyn7qvsxLuY)J49F7}vn4#R?4DD9xg*aClUDCwb-G~Xb=v&@|Gmd}^?(fX5QDtHa@Aq=2 zcy3*%pK!WDTScMNR^b01Xj5plKFqsHV}@J%1bLz2?0W-q)h@?M%~PK6{pbbL4-Jm5 zrLS-=HBPZ7+HR+}-^y?_Js6HL)55Xwsh%3GP_)sR(T_F!tSCp5w33mgHV-exT51D(GMG*eEmim}JfugE+NJ zkP2Fp40BAB>YTl-9m7^)g}onF;rOnK;V5@KPzIR!LstPx`~y z=kmRHDYQ4mET={qC03mv_iM7B{F@+q=v{JcswY;jQ)3%zjQ{xQbUo*V=XaThy<3mh zoB8_MaBNA}qtO68h6L-OElscEh2#??^56dSJa#2F|GW`8>J?s%rY65`1}5`bMO@`s z+9Lzy3KZHi{izM$Os(2)h4upYUZ_`C<(w$9=O&1aJp3B34$02*N9em^mbXhe)7Ywk z!yZr6W&U;5ZJak$_C!zmA3o0x$DT{{_3RXmHYs6vG?jCKWeFH&qeg8IeT6H~55FOM zDb0)5+Gx6mJXI2w3@u?_#p1qv)9#m-0l~!t>-BoDSJTLx|hq}DKNhTCE zN~uZ)sYUPOErsOfIvtg-56G!3O+IC|28E$qKV!JQ*OJdjzUP{~dh9tBjyj*{H~%qGfhmu5=vABy?rK?Htw3ayAAXl$Uh~ov zRJp*6nf2snaew-@$PX2_MbN7(1*eFImKx(MEx5POZb>cv03uV)yIBHXxNutVlN01`l~UT!D=| zLzeS>J{(AV%EgX1Yn-I*0rCVhh~XLNOE@qEUnbd6ceArJwB*b7mCRb%#Qx}3GL8~| z`eRVZ+A9U(bV7$p{`7@>k&MgF?1)WkC})}#%8-tJ*cVJZk9+;|p4rH{;wm0B@}2k$f@k;|EtoVB>b;V?4tx$JEk$PJwu{XRDVLfuY>5cl@+t zS`X$?5mPPmi~a*e$WsgEURg66_~9nIcI8UYYJW^1Ca)*IugMDHUi%%T)~Et;-RO^w zha!;MGX*EF65l%GD7g&^#Iw9VYVV9hpY6%04r0+c&N8nUan`QPWuDLHaZJU^q-=cV z9A)>_LMhXbe91HH&6-jd$mYqeB5n5nmeXASTPrhndlGrRSL|qhl-?b|3iKJl=h+g8Rijfdmd`U`XFX}_ zu0ZE%0qDTl$FpDbqYTVOlG0616Kj}e^@Fu8d-j$on3qJ{GT%wcJ^w37vzXDw%K_li(Pw|ko4e4unnfINJJl4CsFV53nuajE5evrp^Mh6Xfb|a@# z|H%8R{WZQW^Mbd`q^^|f(~}r-cVenp)f>vhx%6Fq=7+QVyYlia&i{I$9gNZ-bw z2(BM^VOEop`wsGvStpl?_K=FFa^-}L z-UhtB=a!M5ILD4Y+tl)UwE`^~_~YtrUSH0JN=Mk~tL`R!p5;nwXXc5M4`^A=nUgE| zq?;ScB=Qq`^weR~NaF9im=Au|j<)uOGN&E0rB?c*WK+(%dXpbIJR9}-J{K*_7w6Od zDC9n)Ab#-vAFkWs&QfGqzC12Uo-#iluOn9U@67eNTO&1Z{FO6#0r)YO{KslmG~)g+ zk~0_&)?0Hc1`!93fZb%p=o!p+-t8_1KLwU8VxE+qx>;x9U26Jux~Qe+pWpI?`^=`> zynpA?>tii-j_eJ(uP^_$-*2Dhr;k@n$Ys9Ha_7#K3 ztJU(p-WGtr?vZ%l!#aDmow^3{XVZSm^l%-@_KC!uF{~*=ImbHQP$m?ie}#^9a|vcl zJWWCMlkaijzLTVJKM$#@L+GRkD0u(=-9_Fm_p1ea^TgGK{<$l;Z*W~XwaUiB9o3}& z^gNl)^TMwTXNmsw9Z9z1rK_`;PvlGT2|x7Yb+1{8vj(Fb`-zKht*6FYtsc2kr~{vz zj@{(%RA#N_9z@?pdLjL~WW+`f8;W-#Kjnx~dR|c@@=z!qk1h8Rg8FT%-*zHjx(znj7tI(a~zn3EpPk&F6XDm;F6) z>#Ns|_`#n)w7U>psu|_^UKOg>qvmA2i8X-@{ofbjT5h}y>O%iJCG#P&jo4b7xrpqS z>qZ;p_YW1m(#P$786#G&q9(5@`EF&*vaYd)wH|$-4jQ0{r*|{|t}YMgldx3<-^t7u zE>A82aoWFC6xy0K<0ZJVJI)*mLz5BY6&AB$?~+39Pciagg&Hr&wWvbwLFXd$E1aRw z-YsvIn5QcI`)XXa>cx8Y$WK0Y*7j`(?CvorY= zHI3*}k=c-}O?33?ioB{qy(4;<8yRuJi+Qg-iPQMdSCLtuUA8k<+Qo!9rRmSe8gIa% zIMMXuyum#bwTKCo_{Qhisn8z1YLuK;9`qlfKV44~yj?P|cep}ppx0N>EDb&7=z&#_ z{0Z=V?jnzAkU>;;HTVoYdc8E_MQ0ljtI+0LjTgs24X(M+FDrz4%;`2%n6J=w@`#o3 zMm4?OsAo+vQP;`b3u0cf%^<%A(a(!BfZY8?=7=!&i0f_X<5+1sONDBwp~Nrg7kSsl z+&6`G-jX;u=B`H0Aw71tB>phZMjlup+N_I{p=(sQdM^wkZjo1VEFHIby`Jo+&tNYP zOfrR`Kur&Xem1;f-P?uv-Kj2WoZJ?Q6+3x-HDod}Ka?nHVo#Rr zP}H{?;Xj%A6}-N$Ud2g|95q5JQ1g7(fNM$V7}1aZm0|Hxa=Qv2t1_Qs81sTB+we|R z$V?rh1e9Y|*E#Zt`x`OQNPcKHg?4h(L3#g7gV;CpDC@>`m~VsQ;X;H~HA#`<9?;d& zGaH9<4;A?=e7w7o`Px|;9QqiFuFDK?IFOFfj|wrcb(|C|Rbd7_%hJ3#JK?&Geo%;% zvIe=gjq9YE9+PU3Z+OUt&ZBs}Hphs9pU;3PeQu8jS7QX zHTs3zRkwaVPYk5jfzi0Z8Zb-*SvqD>& zJmp@zFBbFu-B-?tgtqBWu2pDL+Q&)mN_SM@{BW8umpq0%cRo+j)L2~ zZ5D~s?y|NFoH_y7ODkN@X){?o&itZ>w_XXcRP;*Z*#dswZvZ`XTElO8P} zYzh57(=zvdmc?~a(WJ`bu3G{>lubVAYDx-qyl2_G(K-33_ZZ9WTJ@6(XWuwib;vi% z-i5W3o9$a^30N|@UHjoz&Mh45ncPP4ASu0xi?4B6>E!YAuO`*bOHFbg{l<5G>14~S z8aLWaDs{lpsq6iA8?}$xecKt)cEPmyN$u1JrQVr1v6qh%YncS;PCw78+l+FZzPz7S zbFZpNPaK}XYk!%=K&@fBVhK{Kkx_Q7iIduk<3*WA-^N)+ImSLYooC&fI|pP(<3tJI zSNnO1@^BZ=#Y6EjXG4O_jxo!nA;j$I^*G;&{KX-0vi)t0TpDbWeu42)zp+^~$J8h~ zg#L+r)mYJAjeoxJnsJ{VOz)hu7;+c`IB#yEf~krp7S~YYS|@rmJM+Bf+Sxr=gPQ@K z2(QD;D4t~wS!$e5BbR-p7hYFqhJ8m3vf8LICWABWVDcUtY2bL4`hK31Ku8|3E#whU;O<4a1v<lsbCP*l#OpXw}f6zl3ynR~O&MxSVE5YoDbBj!B6Pp)Ko zR0y2=vaVRIM|s{K$1^w&XFXw9Ms35IFk=7AyXt9%x}+JWw{d3i%79=eBkJ5Y0{7|1 zV=>}cX){v3(5K-N@rJcVYju^u z^L)sU_9Q;^%LWDa(o@+se9>~x_NQOLpbWU~vf)#4W)N}~@|ZQ(d18SBLb>OL^R-Xg zaE9mQ^gHPozs6m@-Kj55UmD5|@)SQf&@Y`{is3gJ$c=!8@;*f^I?hGCiQ{hjsh0kw zG&0WWCJwupqu{KPvjbg4rFWC&gWcuJS0@=z%U!1RZYnb}ykvWbhYZ}R5sPnqIr~e+ zTy>31e(NkgI#*dX&`qva^pJ?3ZZha!Z>d|!T{e2Ti>?E8_tV(7A5>uA_X5$9J5_zO z67!E1NHq0{f$UiW{>_t5{h8lqQ{W(d;6{I^-fDBcoFK>X=hs5&!I=BgT7g#NKknu8 zWy%A0>!w`%GZZFpC}ww{-M5)M51jKlYvh*j$F5^ko7t z@xDJQ(i`%LU59SZ{qePv|9>+UmdDZOKQ971`bUt`{4{K7i(tvKOnMb&?p=dhjHutf43?@$}N+loG`tvLUQ`4!DmFzb>P!M^lt zuv+2T^FLZ%D<1IYeJ1i}W)o8%$hpHqYG;YFzwE^4X5W33y{pp~D-NVs@wOg4=k}#w z@zM7%_-2y}%o+OGY|NQOjuiX7C8e|J18B#&-^`TWVn@?+w1EGMRUio~g<+8KI2z!GN`OtRx!7_L3=N`w5qXGEblGnD=F}>nF2Sz zEAaM>0**Tir0$%*61+@-wT+e7T1J6cp9*9Bg!JVJr)g#}`q zp@1`ajvC&NjyDRWdq|-qR^vRdJ#~8X3MKA3`Nqt9ubjpEuS&k`KFRy}R-Po-^Cdb$ ziP3G8^gSZ)WE}5T-vKb%IQ#kHk2+O|S;p!x{-Zy3b~&? zPwADhjeR}u=|1IyQ2H9Rw#@7BAMB5A)%-EBg$~a(QK++v_fiRBbec#c6LWn;PU7xq zk+{v7STO%BX(ApJAA#MR)%E!riH4UWVRR(tmzmO010qmkCUZo1zYQzOEH4}H6%~1l zYa&rSm-o^d`h}d0L`yGnA-7XcS}_W7p;6fOAOiESh8BZmnr7jhRV(5eRAq9q}R(zO9&cy<9Lk1CdZD2)( ztQ553{WX+0NP0NAj)I{S0SpT>H1L(07XXXhAuC?aXGT zfgQiPk~{3f3>p5+gErK@&(6jMVqi5}GIx*P58s%L9a(m?Yfc=hLJsyvlK)8l$qBn1 z*H=Ir!Dv9 zb+jBf*V{5`z{8}7iF!+efqN`qCbdsWgk?(ChL%MG2V1ghu4tF{B;2>iF^Be}H`YlW z(Wy_8IV?Hp_T5ds?+X|CuAd)dIsGP1njbaDi!%nP*wP@;l?`&-iJBqiTAW;DmVx!+ zWn^5ONNei5tZ}kDI8HkDh>_l3j8cW%k$rdR|2^Qa+_@hw#i*e&*vJJCer@8s&>Sxx zse6e$$t>%6hov<=t5y(4X>W>?=+~?%H^)l1k#RE1Y?f)WV@0Ph%0I>F5A|7%rhPe| z@>C(>g9pylW(G9pFoW6uoS}EO=`FpzEgI;rs*%B(FIc6);acoz{;JTYf(k3^YH**= zQSF)ng+j%lK^mEwP3%~ zk(#?)4=gRO$IL~cC`E0G-_kH*M|!*n(Bsb)au&ncJFq5vOV91ap<&E+rFKk74&#?F z1kR!N*SRo!ZonF^nH~$W*iSE@wvznENp_wqTqum(MHlA1gIOsU@N(e@B8cxb@l14c+y8`d~*4%pjE8 zDV2fxS=11&q^CA}-6cQi)%}!M-!$SZ-!rgciVdy{_}IV<_>^UDZcB$tKW26uWNyJG z`YS%pU_LHA9A8m)xygnxA2YCYE-{Y1%m=y2OzPz}-kan{*5~(zWFUJgGvUf-&^y`2 zx$*zyGakL{BQNT!#qEbXeM3Fu>@2l7_WtA2_akQq^! zbu|*>8q*^;)rwc#OD~p5LyvB(NxCzWvbzr*z!{tJ0U!w@l_awiPy#AUk74UWsK(8e_taTZPhG*yv z92|g8JkyMO=xuO@`+saCo)X6{)`;2@)_23tSgC2X;zw306x^d-e$yW%jx)tU*%+9e zjWU_pc=3_G(3v^NYr(qbHu;o2RgwbwR|YY=>kH>_7AG0RGkVfpp8F#e82OBTTLA^K zVxWTOFMW%52BOZLAT&)5!k#|N$mDgakrIg$)uYg93$NGaDEv6UET%dCGmom)HkCPy z)R+ur7B_3Of@-O#V$8AVoU*(U$w&!x?(arWXEuSonXrjUib^WH&VxuabLH)z$1(yE5xz0Qrj#>BmS+xbkv^Hi{UP z=CnfF`7!x$^sMyQYLM6TwkkrL#IV3D3(22ff1009H7|5~LEph@o>=SWiI#qPC|>JP zSY!ROK_tnfjWM0KA zPek~5VZkM4G7Z$=K!_fblgMKXrO%cv9Cya?Ji9?I|7e~!!~wrfH_;1#9E`8Lepkpp zeN8?)_v5Hm%rLD=E(rCD=SNZVK8rkutMt?)XE2D|hw_W53I7l8^FxB{f0ZcL^3C#W zMFO)J%`%KQ)9Fdfl;L$coJOyPdHm|5Mmyp(nbZhW+0XUUD;%5oxhzod+T}Cz`L_w` z^=33{VaBy1X6R0s@Gzfv;R9wy{3RE@+5>#!`uV;h10P0`LrBg=eNUzKgO%CN^_ALy zvPx~YNWMqM1bO@Os1%$c1{PwLmzz1iaWTr@Ku@d>@}LSRZ8uhdDNeCcJpEp=PrX4+D!vFPw{Cg7h@XB-ilr_)=rP%3XNp4dt+%+$pOKk z%z;xY(fg+obG7{M?$k{#(-E`L;gn|(ZciaU?i0Dx4+HRc4)5*Zc@ShA=;92A91b)vCT%^sS)^|^E_JwBL)r%1&?ixnGqcG~-pmyu3= z5OVOI=h^4d*+{78DvPIj$koyFLg@W*h7D0kKLSk3XY9rNCQ_H7}QKwyEc`a5MoY+ZgQ-E znT9!$dh6w5v&ekJ$uaXW&$erjL#q<0QeU3Lp;nk@q zjN$pUXhkIU?y#b~iQJDZsW|%6iovI?xcbS8P*-|7HK%vwPLH(b|c;}+LT zpTRlsn!~P+GsJNEA7;+r5cSfWA?nv}J$oJzDO|ByQ-qZ9Cis8AQkc!E5 z=rL@!VtbKP9NR{ZtcD*@dqp;?Y@zSyRn}#%$&r~szt0ATWu(J@GP3B0!d|BC63$7iy}eXizki{VN2CXJMXC3~T$#1;+_UfA-M3CE_Rdn z&c5_4Ayw_Z=S@JJc)fW4{D+(g7q34<5#z~q1baI z41EjflQ4@tCHudr!Fs&jO>dP=37AM+|LH3emc~*iu#eX(kZUHw27@1YohEV-NpdK4arQ&Qhyi zo@^uUsqr87O(4dzow!L?cX>KqiPPkNIj)Mtk+M_FpgZhQQdkblUxB5qc^gcS}I$#rh&DO-={OZl4v&{rFQYQ6bB z8!@Bfa|8OU1a;Dn_+gOPSwb){dw}>upf>TL?G*P3ijP0-gB~n^d*jH z9>&_A_;pEd;>QQL=OjAG$))*%lm2K|ClU!CQ_%S*aaT)2*+%?w%d-Jk{Wt<$E|Ir* z&5jq9-K6J)ztY4q0GDes7p1xtj zNH#hIHEEYdk~eYZE%n5w8hz7F4#32Z5x7#8dAN_W;Wo`#T9wO{ zem=~h-cHZul2#m^la1jwoTXrHf!wU^k79F}vrK$EQe#I0jk^q_-{q4h{uuc+0?*S@ zP-G$Vo!y*ee4RYm@210YK7Tjz8PjWI<4FhpUG(XDyibRp0nD0to{V#&=+pPpMKS{N z#gCfuo4+IQxses-PIjbhbCjds3grH8e~i5nfp>%XIk&N6#4=C0YgS^)cYj#&Bk=FW z6lC_Y9B+TZl$lKAbuQu>z>z>`Gb_0aD$lz^ks-OThT*7EO48PtlXI^10!_g8PYeC z8tm{F%quVICgoQu(2YKogQ{^}u{s4)-`erVNh3~irO0>VdS20#ewU9@kiojbaJ!CddsHYBI?>Z0jJW$m z^0JMrS?{>W^uR*V*6>Hww&V{wSh;7=SNw;gENa5s^V&Lcu_DnW*NS#VJLZ)luaI^9 z1b#lN!XuEVPr-~n)Db2%7R8=I89RwHglMkMt10+EUf$0MUNUNIp*+j*C$~HTfBzx> z^bdV0`n$=SdIgfaioDK4QE+-q9xijds{=@$+B%+)3IO=1S^8e@uQBfw?`1ueT;&n>qDQZqeuTtUuHbn0L>= zclH1~bSE2%qPqf1dgw5Kyh3##GtbuXe!O2#bUq5Wdg|c$obv-G&dE;MQN5;G?yV}2 zuqFXm@rd5>#uV0=%t6vSOFsR=r(ENH-b3|BrOLrbChk*H0(T>|&T(mRDc=w=mCc3O&6IoENgksm;%=_GdS78>+yq zTl9KaP4D_HDLAo+xKB4{aa)-y%Z&cGk;8hs3-_@QJH92x%gg&7&8Xd?YXj~rp+1pk>RrPDdDg)LPOM?PrjkFEM?P0> zAj35ps}ktyXhC^snE8VXArON9=P0?J$XG7LdIkusUd5DP5Z@OPla<^ zsA0WhK*b^%I6!{T+ac7PZgR%}XZk#@GNQ^{@{A@cw9CV&M?Iy&v*lrUoomFK$#~hqeBK^o$)o&bz*1rqL>ipaeGjsC-d-)dBLb49s+}9vtB=5`?g2=5Vq>&GGEr|8beWPq2tHvZ^H@;iB zPLk76E3^;>YH!qCyr|(P*1y__PPc6+R)U}NK$Fz0uf}>u;ykmB7}=g)?uQCd|2=c4 zJ2Q)FZWy}rb(4v2Z+u#aj#HR#zJR*UhG9^&HzKEv4dx!yt&)$aD$V=|K7V;1BUAEAflX#3z0;2mJew7}>Z{!#to+bS_4Yh>qM07p~98%x*oY!tpZnXLMoCZynb0 zKMK)gG}oIO^~{gL&}yj>f9&ZW`9>*)z<1a_sv)Rn&QZH+Q{ojVj& zLNR?2=L*H?nZ=s_H~C_Vl6YOX9^QW?kMaolVhZ~1xyQ)zcnzBMVJ-c|h=-$yd37LP zue?z@{-ef3^6bVwGoZx|a!!^O;`Z`5*%+us80RqeI~#FwD19wgv&ZNaBSWitAn!8y zXk5?JyvZXADa6H-anikk2QG9E#ZBT!^@ux;(kisgTOE*q!zwJ;5<<^p1OBWe|1^R= zkM!tRy;%kC3Sn65U_$W*HgqMQv{Ei}isRMD%v*#VW$5!*H{-v)iVNILvSbwbxoyaM z9d1Bi8FF8EKmJ-BBZECu*mpGq*MHG>FO9rQ;&x}M#z;Tb@H?GC@pOfWeGNVJ=P(Cc zZIIIR^_cb{4E4i|_&Ujkn_P$36eI7rUyYlmN2Np~Vqeo&v;i|o%F=5tkeLHXA-G8l z(OQ)ET~pq_;jyx9nmcMM^{CGK>py%<2Yx<%|22p&`N-2-Gk4a(h)lkp?MmKXH%(Hy zCHZ%G^o!JyuRV=DNm?P6{EC;`b^!qqpi0XbuiQzs_b7B|{aKD=7VZ)r=h0u~eUgId&5BH@! z?&tPB%$*;~znA>SQoHEad4&2rtr6-S?3-usb1QpL^kvj262uI*E7ZK7O~<8H|I>&4 z|L_?vt+-;jnKIQfc%8{|WLULitNp6wg#W~3-!rw7CzKDjDCv#!-KSY{)RC1*rjmV< z%M{z&Zgr}_L_t55~qh2*HYar{# zxv!3k=(qeaUiy3@){@3GNbg1S;zXIlIrgX@M#;{LmyPs39YDT(trN^TNHI#QW&gqO z4Kk7(--BMvp_*%u-kf#dApH_J>!`AsJXmO8GSRzn! z)L;!W*s0fyCGT;H3Qhkq&w8^4ZxTG|lgxdIXXNTEHO7&znB_t3#Tw3(SA^oyE8aGx~r;a30_Yw$oR}$*333V@$JJ0uxJMJHFe>kJ3Kq*c3-fOM-&iPE# z3Fqgk=rE)$eeR`nIKg>Df6hkq!tb-0zw+}vCsO|^9|Mnv(MYSr=L_$lt<*6dpVpxU zzyCi8^gfr=p;l>f8OJc65lBX?&dA;v_WD&|-nSmLmYW82n?ZKYegpRWHlXP_BT6Y! z&~i7qizf}3`G~zwBMtDsZ$yEI0S%jx={SWQ)y2pKh@vlQtGV**VC$hT|w_8?OBN z9#%YR%2@~3-M##N>e-xSSEuLs6aA3h?Gtftvc7I{J)$7 zjPjIt7qZh6yrc`WLUEjXzU^E`+E*i2e!Nl=;+fl9rjm;5eC6#xH+k}Jec2l9DJQgn za;QW@dHXgt-#O`3KTwDAeu?}GM8uG=7)aE z zEKdrI1roSKf%OgZ#I2S?x^~DHPtM=tYUfEYFNZv1-aopF6L!7Im*f@&Vn3{bhbq58dfo>_DC)v++}x@Xxjj$F2wA&~E3PoaCN>^7Bbw(lbsw_#uhQG-#;@m}yGrKKKTkPF*ha6^BeEl|G6Ty$U%=0$l`~`Z z=}dg{&qVCA40;bU5J2zb$jTXb_L&_evD9-qn{l7ITBSYwyJP5kJZpw|12cZ~Kh+*& zL)VAY`JUTwmgoFQEA2Q$w!zP9cC5H*LtHts7m9GEbIA^U4)rUw9Xh2Qqt4LJSUd-# z$C4rUjQO)(Ir#RNU(<?cE+u{+zEp5dMKr1L*sQoL7?e5<6A_i8us zt>q)%_5L#Bi@!{o9w_mRJS6xYy}};8()U$>#EobmBMy?upjAo!R3GW!>LI=}d?Y57 zx#UUiQoBfiO!oAZja7ZcLe^?*M|x1;A|K{@%B6i?a;!MB#q<_-slYz>Qwof#l`qz; zJh?S0k360{c|omFJ+MHY^v##pGk>J^JbwOEz8rh4Krwxu1h^N-)Y1j==xUyf>+g&q z-ef&>qKD*?f>~0Bm`^!mvr571jlM|gIjfc{FgG?|;^>KNUx_@%GRYQdFkI1+7pTDo6Z_3RXmBi7L+`y7z4p_8 zm`ML3d)gPz2}j#G8r0gXK}?GXJP4&0xGW4u$AshiIt^~E4#$kb&Od^ATV|QPsI&6S{zk)|vO?5osT+7*VwQFry$fadv8U`( zQ|YmgxWvQtPUHmGf5KXXjLA zOiky#lS{_qznM7B@7et?wV`~@s{T;pJw-O!olK~2u?N1k8R1UszgWfZ$6uSwHN$_G z4L9qP1$NCwz8v+fs?7cd*%7;g8S+x}FlssDx=($D8glS#8%ExwZ`fo*iIbdvWiao} z`=$C*cD;YGV{cFnoJ{09PPE~3v>jK-MR}6Xx#o82>by^jWY{qHBsIwoHdt!g(U^M6 z_x-$=`L%(<8SE3ysNO$+T4OCCF7@Ep{|D6wUD?mWZJhRw{Q zF)LN;`F>ecja-uz?78Bed{U!CncOBtV#(1M%=utypH$IUlVwO5qr47grY@Otx@(D2 zu1>Oi3m}WJOrjW=b-YCOw_mvg2`y!mdq|R>O_i8(*B9C;%!2k*BIZ4{0~OhdJIK<` z_d%U}&W0Yahmze3Pk6p*)Lx0nhm~+y#xry(bF^oenboLJ`Kk(?Dv+r(%nwhl`r^<= zC02A|mZl3kKDRR87pOv#54)(_G4pjtiGJ1Sot(tH~3A;Ov5#g9DCj@KdbP85pw;8~`U4l$lOyeP!k zRY)|_$${@QpL@LK6&+_0n^Njqwb`58gemeA8z`bP&9eKX< zkWw%Y9(_5#=oQ*^--1pHxySrq zLA5w~8)N8?9Av?+a#l<}VZo}m79>);nzYM;m0hgx&~e{M%^~Z#1snGMKR@Fza<@yZ z36Qlr{N!VyK$*3+k$fAi zvWmXJ!YE)#iLa`iaJ z-|&<7eGB&3f#MX{Sb~^a2;JFO-iHT> zn~O@C_ap;x5j`M{%vc%BpNHDKDbF{f)Owo$Mnw;yFV&Ib2(_xepzq$A)$p z=s$?uuM3&*pw|AgtC<{xOcWZ!jLJ4U4#t0gzGM!%3?%!@jqBAqA6bx7UtB->NKG)PEu@&~D-7Ju)DlJnSqG}#aO70e6AF$W#W zKFkU_Xn3aX|D9*w+4*=*NBW1 z>e(}_cs?W>HQtgZ`;|SJ8a}H+$-2s5kSJC_6&928zsj@9Q zRjf(L;;v7YzmX}@mHx%@lbElhrvJJP*R5yls~GK%+dJs@Y)>zvf_eJN)CcItSp1P1 z!6A0%oHMe|)rcw6>BVTtUgf|P%op|$WpQ@Uls{82pS>IC>uznu*hTcCggdDxlKs`2 zy~=88mi6XS&om~Z}B)RC4BH9eUC=X74*%}KVzFp76R9~0Gadzu;A`eX0G}E4Cd>zmip|bB?`4ab>qfoQ)R+! zqb#O=HKQnVzB$Zw#2ICGGe0=unV-EtpUgca28a6NV=wAf*-?1YDH`qm<(hwyj4SGk zE<>rQdZb`y33@%Pe2=U~{NB&kDv~*as@eD&OCP@73TOJ7@_&=L#r5)0HD1H}6l!12 zwqEhQ+G)1rVrxzy9lDGuYh)t1cK zPs|}k>hYv5dlTF<5i%+hp6BW7P9(3E-s+m%&$s7Vabj-{CRo_*{Lzj*>+SFv$@NU< zCz_58rS%4K5hDVmDf=WV-w%>u(ezYSD3B9F74RKImhLTzA%E>{+f^oRK!*v$5nz=DHeEOISg!FvyUfa|V}hn8|}+4`pB`e)6?x z%KiN3mF$^5%U`cE%2_S0(FkcHWn) z$Q1TZ*HBK8aqVL6vzSK&PBe`q?~Yw`^VuO4xyL&CUU)96F)bbux%8XH zbA6{)kyv2Hg1*dpEvJ8w=lm%HayXyh+TPucDkbP0;2GxNDSuhEzmb?M9`ZSd+{!gU zVj4^DPrL%>emdc*8$I|F6&O*{8P(`RwN}<(Tcid)!^2UwcqIPat;O}b)NuH^1U`vH z<5l#Abf;D`HxA`$==olm;Y8-p9=O{^-AQ)@VDiKVBp6d8mSjS|e+^?+<84)ye-c0gY3 zKqV&d+33HC8Tx+YMa-nXdz}t9j_6?KUfuSd>%|}=)cz?LzSD?7Cz%PN)*9c+2>VO& z2iIEBEQEbEMXcEQgnQ&^*?3N--r)=EQ;r}9@u)%_m_jb%5rw+NQ?8#EIs2@zPr4;1 z$(L(9e`Oe@{Apht-l{~ozRU^GN7%E13a_U4;Y%SMylgsl?dTA9oZiYD9dw8IoDOAI z&nou9o#jmOh7nz<`v$9+W#Y4W0iQv|>0|u&Dt&v;$w}w_dc}6~^|BRe=gsuw)5my< zGv3ksdGI1dMv%Gxl^l>h9m)QSPLXT$S!NChK%cVoFFy9ghu>VgnyWBzl`lGZGRxIf zhXcR(njFyKrAddRCDg%dr6Po0#_PE}YrNzQ!L{>4`c^}%$7`bryxdhJAJ7Iy8IM?7!NIk#V)j5o@!I{W4PkyL56%@2<> zO8C%c>31jq8`k?{vx9R3u2;{!Vz6jt6m~X^!4mF0s<(=Px)5jXZd|*leLJY1H{!YG zKORTVDCPmUhN@Rmvz}-{=~(tS`dE?Tt5AQ`E7UzWyL4TkP%q>D<7X0imU9f^5wu^P zk>4beEKl6XI_A&wG{+BqyU9to!VUp{KLoT?!8urkvi~rv@Gc6k=0!vIhU@!A9q)5` z3D?m}xyXoX)5!WMYNU6H8M7P%44fZM%VHPOTq}B0BVXxaWtSNL>*b^_NK>e{^x&+D zKbP!QsQYXoKZ!ZQEm!u*_|J**fY;6iW)Ej}OqOG_=wTi}~V0f0N>RERN~v(^<{_ z)}wB6x+XjC7li$f|E0wVa_(};NwmAkl|Zg1{^4lZlfL&s={Pyl1_eJJ!ToKI6=gId?{8Zsz*Qz?b>5`xi>^zEq}fXk{^K*7NC)n_|PfV?NUFa=v(d4?}*3 zSUi88fhu?2!#KcKJZn-%+(G@^v;lqVlRL(Jy645(a~1{qFv0>FJKRB!+O%Qaju-75Qa;p zSZaJcZ|<{^o#DdXbp;;XV~_TWI6O;ZKQ-86n@unO-8>1&3Bx-2zjQ8UoZw#FIm|~A zsi7X=^SpYESRAjJfd&0-SVX^7ZpI(^{-qc4O2y&>^|f9D$UPk6E^on5|w6CBTVzQed!T=XDc&zJA}VHaub#7?i}?7KoNHf^Ub zEX#)Pzq}~Si|9%ubu+0ZB)>71u%qcf2E)`qqIo)UOHUsi3PpN_BFCuT^l zo&n(O^~Qu;5smTG1=w#K6G>I@t? zZ^LqOC(D<~mjaJ)tfkLRj%J{tjoR#SSIMFd63Kn+(HF7!Iwk{|-}vw4+~8f~d>PB< zM#9oqc%I9^_BwWS^{69ty?C8$WS1E4Bkyq;Xi}N`p!2>GfB28Y_S7<)t4GcC8RXB} zvC>*sR#g8hXHvt^gV$~Q68!n8i>#aHA#0B~(VNCT>v4SF$I+*m#M#WMdh*Ud{vhw) z1DVXc9LwO@*3KMQU9l!R z6zWxJ)*#F+uP4=$MmFK^DVOXm; z1P{zWwNf_Z@ZUR}zVE)g9=e{|Kz3gS`gHh@=k6wR{uW5Nd0}w#j)U=31{x*vv zSC;~b{Lu^5ij#kO(~NIJ>e<$O8Rvcn^{fCw&KeU;v93)rqde<=A_aJ|^H+iN$^i3ad zkzRfUlA;d7>PNAdb07oHH!~NS;wh86A=*~ zL}|$V(bVOf?Uyj%DnFiZ+<`-G|K%R2H@oYw;T*Ydoh)eYPM+6+WGV5R`<2V|@r^TJ z7`4$m=N)LqT-`}>&35s8853&2Dqs54m{I&tZjWqytitBHI_3)K58~c(lBWZ+WA@02 z!OYvGMkB_FS^>4vsv{KYX)f&1*y@e*g}6VQmW!yV>D22M+%tYz())!-ka^Iz)PvMpYq2wpp2a})JR)rb-cU^zO9_l4l zY@f$HXnW2YzWR{s7fpN;^De3M2T;p67`IpaN~)l{&3RH~!L*JY_NzNtu;=3XWIYY?};OpO=`hs^2`m=s2@w+t{S@b4Fa;SfcqsXR76+C^?Uis(A2g*dRi|w-!X{-Qzc;_WMUqrnNPi6bnk%(p zr_y)wH&3yjIzLh3&eI21Ga71@0dJ~XFoZfn)ka2U!F@6E#XMZ_p{90~J~ir7Wtt?* z`KmscyC(|e1{h$f#`k?PyE9Jgk%#T60j-XP|J7t%UPxWPIJxosITye4MT-$pSl^cK z`wI(d^mE|&0QPTvWv7+rJS^w?zSGHqe+JR-c5{#H`bDA|mG7E$Fem!s^pRtk(R&O19S`27; zJPY%?E7X=6MsfM3L>~=%t>{y^H6#n)8!Oa{&L@fGy%PI*CbPDrU#uv7$MpZsPu?Rz zHGQz%MTc1GR;`!O7kN>kzWUQ3W4*{vTgncUk9=SLdp$=nYrAN-#8o5Lg7cO(2iebV z&qBFP}XY<&0M3zsm?-7G#mj znVGOhJeBM|`zH$dI}P~JfHRzS3U$mhdb(zi6*7qV>)vGl^ZBrr`K1@^i~l*E{K^~i zu#)=e)d+T?K%tHpWt66`d{LC=oie`c89$PRv|c6zAH!p7}h{^Ez+L`OgHC151`A$v}FQ@R-}w6U1^JEiAbAB?6idr>*&zk}F|V&`*gS%TD}ANe4!^Q-{+RkN968nip zU8{y*Q17&aDuvVgIBzpmS=K6T$IE7?4^QkI(qMqr)Um94df0`akZQ~Jnc`oqO=}eL z#uT+?cgVa0<ZPcC+SVQ&n`$eS(=*iE1WPbZvD+vTU)}kxmk3} z27c>J?-~?04fQMED$LqC-RF6c^zq$Zn)aUgVw(47uQ*jT%I0>7@`Rm7Jqo4BM}LEy zy`CsPwj0F3KEXpN3|)-{Zuy)P2_QJu&Q+ zF2C7V{V7=vv@%FmQ~tluD>=X@dm5yQsbrEQ3`vs2Hp%jgQE+l{hkh*J&bshf#hgtW?44x)T1!lu&ZLI^^SrV6t-ta&Fyt zDm$W$N)+wO{`Sf$oLxtjfH!lie4d}-v+sbPl3XZuqbsRFKl4TBPfF}o`{LYvB@89` zY(K5UW1i{9^Y17d${vrq%y!P=Oxjh4t`Rz<^IH4yD~b$oYDC|n(S*LlhwaJIxf_kT z-FW|AB8!JU#Us7B=I*4ww`nvoI?^Y;Lx-%_)U`L0F>Q^;_&YI3aPWHOvu|{R7)+Q< z?cKuX6g|FSBXoH5g!jOl82mk`L$Dj!kiOCIeZbBK-ZOqr=xOiBOf9eZliQgiO`tb= zz5#{3jF=H)K&jbAOf5!6LnksDnljT#c0|ty)MGN4$DL$kM;K?!Ey-}4$~pHeBPKD! zQM{HBu4XcaFVG{|jvmEjoK3%Ek3?PeYYc<~nLwFza0wroHAGGRz9^MeGMWY{9-#R-C`f`8u zD7=w9DaR}rwloV(66t4jq7SNzw+xNgV-f~(L-+d z`%2z#cQKr*CrhkK@jUE7t;tL5qo~DqttXkSJ*C1)ABp#@E0s_C%B{BaQdL(8X1L3V zRQj==`pBk-?9H{)w^&e5hGqLn)Gl}VSXL=JyLm~4a9o86sX|ugn86kT*zsxQ<>-BCS(OvWXG*ff!Mk#Fl`@MK~M9g$hAD_ z|4@OXSqiAu7f9>Q`I51m9>;u#N$i-Vkx^gc>{V{v-8x{@IfM@HO!4H}#X$EN^xF3hI> zU6WeLP%Yl1vA4QMIM&zEvbRjjjsXqE6(J{a7W1WQb_2C%|Hd3WUgVJrUrCSU)MHjZ zBxk5Ny^C?NSg|4w(>d?hRGqV5S3QQF(qmmmc1h3R?>RH?NncfLV?CB~?$GQTJ4Bkq zVaDwLyjkqs$Y6KXXzB|M^k}nz{YdNMV7||D*aR|h9>R%$mQW7!bP+a`tjAe=68}sm8;a3Sv0^^;5qc|H?Wx za6F8ij}~?`OtrJ;nC$nk2 z50FdL1Ebdj%EYHiNxWTCmX-67uH);;p_fK94K#!`pbFpn5wSw62l~K`C6Ck#&>(66gN-4oL`QQvl^ zuhB{m@<9bGYn%`;wtfiAz;d9zxJTgSq2 zX;L`wh-dg^)H_>~!MKjy(80VnYisdidj!TRG^kOX^F7{cTa{#Rz1INK!%^*#7DqPF zPt1EN^(1*K55n;;H9KV|etc6Tp5N8r{{NnBaY#5Bi@ec# z99Tvjc>#Y<9jPnt-<`YocXa1mYZQILQ}j4oo!-b-_8kJ)%eTZl2E!@O=Ba}R_VRoFP{`G~LR=Zg0rJ&c5_d$azoRjin zddi7kZ>5G;%Z~h}oYS?YKZ*Cy9=&#hzTp|R|M3sEZD$Q0T){u&d(RK2Tbx@J((L)ekWNE> znq0qTnkI z*|=-^oiCZDmkX<=p9pp{O&{$M@}x|Da9G8CY1`e>Os!rYF~t|ZmiG16YSXcOqtiBO zZkqnN**twl-OncNl+C8dDF;J3S7>h1RoyF%uO`a^za&YWoGPn!8RX#PBq_TtNlY#1 zQ{0~*#ix-~w32;jedrPCZCS*a2lX_Vj9Q)ST91gW&1U*9@OGD`221%FbcWhnm}yD}9b{mAJl_Gs7l2oZ)`YzJpo866{L|V1~t0hbA|5_+g9Y^EL|hV>+mk zxEEYWFXKZU8hOW{RCUfkgLRnQl=Ho@^g$LxVeCO>Tc+!f5v9ZGU1T*Dis2lXXYl4a zoaRi)dXe1jV)QN!kH)r}(U`Y03YG#L{ZY(cF4y5>4%uO^$>G0az^!2RM9*NB?_UG9 zIQaVrBMy!-;@B@E#+4vIk@wi~ zyi=!?BgxzkHgJeHSp>~XDlnY;!lbbZ$S^H@`h?@+33}c4Yf*C|y(%O4^KdV7;T3ti zd`_SBiN~{xtW$~vXirbx=J%UuQDsNrFe9RI2DF zOWp*@^kFL2+6Bt83kqCaKxSlJXWVE}2z9zSqa?2>oYvy8J`%luYY;&%hO$*8bgv?z zxspWy&?bGlDaB_2`_k|ktroklJ2M0Dk?Uw* z&Q#l&k#Ot`zWU~11^1e-Ds!K@CGt}T`QafW=zvmJDJwuWAZBJ}EA z&|&vu`c;xs5HgfZ+m`Gv;B)aXpPAn$q@d1J`Yq@InbSBMk={HH`|;=E*)*h~lRCbZ zliFFUP{+QcZ*MNO(x(o*TxFEzO_<-DwNLB=66D>+6lt(vpA2^Q$Bgg3C>Tr~f?km8 zZTv9yT>zHTYcZyx4l{pKS6su)@3KUIPtYu`O^>Mhf@=*=#Q$3rY1Vf&!&&iLa%+r7<6MkveQ=s z^gi^VE->K3Z6hMMCcNb{c`DhA8x1_8`(&eOC$h=5a8^;=Nj=S?P_NgsuaiE9u>+Z5 zR#8`fOF!&ldN8ah^3{Kz6n@P8Kpgu+W^k>p?}veZ{V<6?k2kgPoDF`sRVoInE5%@2 z{TN)X6T>`e3~o%1L3jFhZkvpl!}rYN3waE|WD#6W!RDIx(7n19vXUIK(e%#0wqW2Y zE1v9UA2&U)F4XpiQrC9xr%-#5ljg`smA~gxWLaveq*qRn1;?4!ZImphI;qf(np4dm zHOX^pz{Iy;%&36=f&*&KN{jHUKJoL9TDWX z(J$D5d;L?~v!}8r;h-KfGwI2n!M$;7a$#p@!btz%2DeO1{%oeNnLNgx}ph%q@9OVAG<82?Q>Q-0&_VN?;aepzm2FZ+#O8Iot z32o0R;MYol_He@Aw$AVm>=$=hh&MtO6=Ld*; zYgcKI87LuJ8cN-4FR9ltK%5Rc;mZVv#CtiT)kkMEpjWS&pEGJ+3`ayFnfq1^D$da0 zPbm8_m^EF+nS0B@ahUv@XEVM=gScKKj-_^ykco%C&3N4|6DP^8%w-mH%Xc%B3vy6U zEC-voRuu1NN5pNO<@4E(Sk*_4Uh|QG>x1Mbxt)Kls{kt%%Pd7l(VGmgDJ3*kZ^JTy%EiO7VnD`?S_u{o!oT-K5JeiH$`?y-D z?abFBwGp$d;ap3X>QSvJ*_9W`tU64e%5r8+$J3WTmwD2wHq;DaZjIjDgO_sf@}3<| zVPrzbr^>oVDdI+6#!hVVOva5KCOx(OrV)*)0W#9EvfBGvMsE~Pty>(=$oN^6> z>JjIchq;cn=If-OX0MEakD0yPeq2k-q+k)xKtoR$kxT!%d$kkN?J%1Z>e76jZm_$cYK2rOvM@#N`_o%ln7xieQ^ia# z!?buMUI(dQxXJ%jxHQ8BoyWfyki6ny8}Riz_Ynt!SD zXVcsGl=H3&T({I#*xa+Z?vj18$BN?IZ=7%Hqz)ZJZVRs?U#{zKxYn2L>!d#VIa#a+ z={>#4b(B9-s}4q4M|M(6oj;D=RwAOiKj*W4P{yd}Kc`1FTE|XevK0nJBhQVm%VHhQ z^F3^yV}v{R8{Ii`2wu&3Yd{J{^P0Zh&dRwjJ)WM~Sg&R$Wd9yy&2cm|LbQQQQ2RH*Hw^l#6D%_dVG$sKl;pj?C9h!RYw%ar)e5Iz05w- zml^o+o4O|R&a>EeT@Ug7hWcpFqb_>i#6!6CKiL+ zQ=g@ut2=pivt0`00{tveK6;EfpMltKZG6~C2vvS^%!oO`Ydfz0dj`8McZH>pRC z;rZY6WAf)LMLqXM8EQPQUFFo}T&eBEY;!idPq=PWiMQcl(Yo>`@voG=K;8Wj`()?v zSy#(`cZJzUmHbB@Um;I$QXFceXJAt`8=kImm$FR?V*$m_w(!Fh#)Wju(`u#b2% zwY6P5Z!&K%Z)g}E{bp}(@l324L}vd!Z@E;QJhjeYP+g40ITL+nVAiaOr)08Mx9H5C zuz2(Q)Py|5Z_HSnR*E$-SJH}vBWF-79>&stx7dc(PdKYNn=kLm(m%ML8fYgoO8VMx zt`+;cZvB-7^sx@##7Uzw)bF-hqy&D+b&w{WEP{rI*)K#5`M0m08bSshQ{TMa+FN$M$P@p{WK{6)ozN}=&6$CyF-0j0Coor;%wFbK zu~<~b4DIIk*fpS@d?(-V%#$z_s>Zcw6l-f zU)(no$X+e|bVXuOD1tflIrQ@;(eXx17GVB$e1(lhb;Me#V8o9v*Q|+S7(%5#Hi2`ErSSNRRKa2vwUg;Ue|p;(_8m zJXc=Fy0Uz_uoPe*;F_mg}H;`6XsP%KV3 zGO)_QUZ1w^vW?t^V)0?HD*NG+Yob=eags}HiyHpdoFw4%bT&n&xR3v9gfs1 zkiwkL9k0*Mvv>3l{vg+KjhEE+;GXN?Ww!OoM9h5XH&=WYRcVJ`7&n}eW0;%=vjjq zVEQ@($-O{1CwTBW@5BA=?_C*)3gs-Ss-N_vUvft|Em}nI-!;X|t_d4@>*~m~?+VU2 zH2BAj*P)H`fm77nJ9$Vgvf;;5+sL0lK5tX{$`jZ>w#8lS*O-k7WZ&F{Sd4qk><#bV zHOX#LznX$PNM2WsI9sg7=PGsl`E5L9qbgS}chw@jv>uDUvk$$r9lw_tWrY)cQum{9 zhv&;?n=RA}=%1RKBwUh=g52cVe_%1S-P~l%ZbRLYzOAO^ zj1s+&+DH-h8aFj!%>e45-yEoOB2iX)vpe#AG(v79qgw>ehw%<(fD`4z1r_cxk8%2K zGR8$&;6iO-gTo;AnI);_L$APM10pLh>rg_Ww(99)s-i+wRTL)AHo{xUK5ObDl?$iJ zS`YeVF&b2-V5r8&OX?5V@f>B;zhioUJN3ia-@3G$&neT6M~-XF=l zJoiJt`SsJM8l`1>AN=a9!~MqeC3WZAKAwBng?r@ZH1fg@%){lNP^eRSCCYK`Q><(0r8vUg zVQ2pQ%xuK=OOgxZ=(XePTv$u*0=45hJIFLoNS36H^o0!4VM{&cbt;lWM_=CBrz!HB zvx1r)QMk4u8E?O2!Dlo3J2vc*xB~jo>gzBk$%xRxWG}hVk69-{rZn?Lb?)iQj58vp zFZtXF4h&7&E&ly{aI#Sp>YicdWH?z&l@#iPA_n<;*@v?w`VH^${h~HqJDGjNFh~OP zyH}6QL%B9aJYP#6-)QT9oiN*Vs;Sw zXL%;jkOj7PJAEyUqVX}3Sz5l2pOgyqo}68xDyqaH?yrOS`hQtKZ^S1D)`#sCiSxmZ zkJQwb8{itlp5L;}X>vC6v$hgzzDMC+9<_Q6b@R96=xGvVO}HPNsaYI3#F;^3awmD6 z6ep{G+;k-ZUy;>aiZh1k7Cch$dgx=6o}h--jXcfjWE@c6@9?VteM_>Ji~h0#8)p~p zMhrh?A@@k3E=HeEZf_qPeM#RLIen#^$d~L(&4;s|TI2?%X6dkoGYjLCEbO3PZ<9S) zuJ=}9Ri|iFh&Lc`D*dYb`VI#AG{4a2+n>E0kGLltl7*N_4rG!$ndHpQl@HN)zJdO` zUs>2s|LM}mB*GBVeZze%63a%F;Cj8r1FoDRQC2K4N2 zfvPTjWcA2@bWvgSa-Mb0GaqHP;3+@8xln?5X;s+%G79axFei@!I{#}zSt0$$K_~j;dRw>5n1l-=!Z2W%9xqtB(g8N%nt*ub+VvuF=m`k?v{&#l{grw zLyKw#Wa_g}jJ`!(6lZ$%__|%=(gU;ikQKK+@%BQn1mDh94qY2`7%m;(}MxobW`m8M$TR3Iu?q0A|FqStJDxhRCVa2`fK=8ks`R9muFn*OUqDtWAlW$BsXd8-$n+lMbC zN&x-5$xY}18*0GB;QusVYMJAc&NU;W@pwLci$U~9@xCz5O_0(b z*#jOLg@)~nID5l_W+N2p!LGcIW_qKcL5HKO$zu(rAM2b0lMfkWYc6}wheadk4Y{|4 zt!P#Mf6rn6KYqp=mUX6ywKkaUeA$s!pkCE-SIdzGzy~ zrg!?TLW9%q1U@jO81A;b(`cosO5*_2$F&1Z-y}Bp%%jff(ZTgiWu^{KUtd2dWYCRq zCR4jEruwnGAIL@gGBQafJU=L(dl+OvcCsA)nkWyirpTs+336!TJ}Gcck~K})@x3lt zf*S0X)$}z#p1Vf^bIH;fW0aztOYdHmC`niM%CLyNQg%U-RKB}MUY+3gTaqMWrzA_* zd1?*RJYH5zl%Kl|VjXOda}AQjXU0CM#_Zy9FN1WCpaSo#AAMst$a@OXC}azTn3)&pD*&m@fk|wt@XuR&uA!@ zM&mm*p_WIZQAJCCxsU*E?%ya(8Bd-f*YvxiqHvL3SS>Xq zU9A`_YZQa=L&;Vc5zUSS<{iU1_tw+%C|qYak8WNq2LJNc%G2gi(`E0)U>&=obhy}& z8P+_qSeKDUynr+9$DHr1pf5a=p6E~P|7&HyMuib+oUg2%$LG)nBVKXdbDp#3JJhZm zTmu65@gAj8Q2qhu47p@Daz^xb2^rX25A~l7@R(*mXX-eMK<)(BhRwS;i}+x~l^I4X z9Zuh4X?6SL2#m~Yiu$e6UkbqV`JGWofN?8D-^dw-_|>swn9ev&NbQq*LwSm4I}kn1Qb z!hEe5*NI-ppINxZy~>?K%rQ5!;O!aS~zT3bC@_0yXvDI=B^*s+M`OaN-^mUg}HGRcexvtb9mvQS$Ul}sE zo}_jNU?-59l-$VvfXe|gj{OMJ)7-@rLC$>{cjl8C|uGW(Q6rVjfnf2dhcm`Y8ybgl%vD3GwX3cTE!FP~@SN~5Jt zxYwvait+QkBA7pAANAgH`7)xv6L$Y8peHj={1Wm-v&JDqiv5*)$MU5I&(rnn4jFcj zJrX53UtUuPqu7f(ZHN>5gz2v;>;$)Cxe_tL8I`*#@aCsOE^i9QYHBj?A8D~+l?J`n zhU3Q>`V76aX!ApZMu);MdVV+}cZK6KXVbF=hhq%SXzF4byxGDIK_B+hBLC)T5>B&%LFCphDj#kV}UW-HPz&OlIV?XpbYBK+w8-Fmv`6LeY>6eiKi}JvY?-cl)L+HkfHCwhI+Lf6O#jvPICMS4IZa_bPNXu^7@)^C ze$C_OWXvVRG4sOCrj2n}wOY@4I&*J@%}AT4$dlwDUs?Sm}2I&aKa zIx`ay;p_@oO&?YWGiBwO^*_g+ryTZgr1I;iM_ryyrVVwhfj#NZ>R=}4+YCEBSoN2Z zVc&$zxYC&jtz^b^&rBpNq3$#}6Q`-)JgvqVNzqJn>}bY;YBscWE40qYl zqZj!})JSfGk*B}Fh8|~aI9$?>#m9JVuSM2DU-E!AqKKy;sL9!gEZxrg8gQ9x&dDXIG!7%n( zhxth7I5!En*jP*sUzvZ`Uwj`1NQXu$DKtbWFVnoFprx18ozsx{1b0b$7$k>=QG0k$ zU0UVWWAB-}bR|P*(F~Q`Z|@@JsrBUGK_4k{xvmtM;wnz_>dD)C^`!mbda|*&mq;J_ z9KCsVc6f?1(noeI@f4%dM;cD@5Qk1B4{AE2REs=mb%@$fP^FKT?SySos{nE?f{72Ru&-4X-VvD;&} z!VGpNpkgaEGl1O;3@UaUrR*+dz)mE->wMnpy}p0I`vVt84h+NdJokO?z4i*~rpvwb zhh?lEl5_mAfc)N(oayao?~g6}1F-3U7Sk4KQM+v*4i3@c>pOpJi2n~8px5GdevaW> zYitk>G}0n#VgSbPX71OyAjA#{#IF@vbm70{RscSAXC~MSu61GoS>w2dUeOydBMiZt z$TMVLue|(Uz8rHj#zdeJ@f3%$Tn9@c{+Cl~oKIYE4?QiehT-Y{FeKHX-t;wjiQmHU zOh;~TyKu}L%v{W|5zvhxmbZraom|KLSCG3xET_%{dV~?XxzwJ%sCy$YsSJHr$)#*t zD+0wMIb$ORl(vjI>KPUs=UN!Eot&0Zskm1o6(OM(I6Y%_$Z&coM$kj-9`*Y9#BT0e zP;nsVtHd9dldrg^CMZbGPd*0M-5zpjJT6+$^$fMC?QHP5M8DD>e7>i0&bP$|-ziqy)=~?)!-hBCxgNOQ zIzF(XD3rb(oDD|RBo}Ep{YzblQ@*jG=}mrYr8i6wzjnq7zYgREb8S6P(65TT$5A%w zP}g(q>|_p055BG!*YgP*Iy|@GVhR3S>0BteRtwMC;PIx6*|NJwr_YH;I=S8{bKN<+pS9ST}#*GHoqgx zuf|U?Pc7FrDPl-(bJ3x4$tRlDN$x(Obn>w!wUaLwI3+JL9WoDibkRJmW!I!9lUMmD z4x!W8;oaL^t5ZF>akH8}@6%(=p?y}FI}h{i7}GC7(muyZhACcJwTcscKa(U6G05OS ziK3z=@LS_(xk-)QO!_(9I$)9w)eQ2hVXQdaG}1fOAc21wCGU$t3^{RfZ%4Gm)iFpY zJs$hV9+b)K%^E^xuek?B^Ezb<88V-bgV7+AE1tA1M@-p z)6m-`Ujyhbu<=gTt4aGn6F2jI@HOK%Q37rv*ex_FlZ|4xgFHD{4(P2 zJR{0ZWp86M!o^~O^DKVcpda^S>cf6A6W|^B9vLPe#)zlHPP({LmqyMek##~*6g!O)Q?AL;um)OdGkyY@r-yp5#n&|O>lFe{-rdrnLS4A{*{3# zYWCRdw`L7u{upb(T^-qbIZ%hPp7X%<)Txvr@6a@KlQ?YrU1(gik ze|U}$38v0rYYKjy;(oTD>%M$0B0rIXLHu_)*MIAOnHRO)U6wLyC?Z5HgT8x7@E{lI z6lpJ8IqTck$&OrE`f@K}PUp-LSny4O(PeoKybMB{z#!CXr^U-KE%{{34ffnlJwgO- z4x=}9GjbWTS>sF&$GNBUYI;sA{SS2$OXx$`Jq6#mhtB2xHpep;6|3bUNo-j1gtL@E z%oRIAew?d^So2-PEv$vy4EKyXb*?#1#m2haXW_vDZW19`Tl= z4qj5>iK{55Dy0!?kfb+u7*UIu_)l^y&ojGoN}(wG(UY+xXPAcq|L2pohu5fbPoCeb zNz1Olu==Ndgl^cf56T*?-(SkC~=_y4H$X=&ZEM(niS3eb(A9JS2XQynVTzqDo zmh+R|E36N1lmC&FrWQ||Qd}E)O3!qqDDBizubUl)k^^#MvmJK((NnWgv8)}d!2U=- zj9sFItpl}7*Xf1wJb-zSoZS=kC6LoiyHL9HE>>X zgxKLz<|@6(MDjL;rtqjjbC0tRlZA5^UwRLQ7h_~^qnsXhSW0e8kX^xv(xR_X5{Us{ z7)L+j|2P=&9vHGz4WAz>Og}=8_cjkA=#Ike57RhBC&iR9RDX$aX%XDJ=O3p8w7AMGn z8%BvsikF4&K6Ly|5!HYbQvOlt@Az(H__K^2?XD5j z7O7YL5Vx%CT^2^*&Ol}>Byo@4#QEmcaID`Nf&Jv5edO6S>JW8J<1EPZOo5rb z@~l^!iE46Da~;pqZ=B=)SG#v&9j|bcFEzd7Xd9lVEj=XjmW$lz<0wZ;70aN(3IwoU zJluzT#%I)GljFujuEJm8;)^9Bk+y=lie}Syj{qF zUy+It71>L0A6&G-La)6PEM^~bphO-*^T^kTrmwrR4KC~z{Je5ey&HA4KU+v*xVJnj zQpv0m_R^!2QcBlRU4V{D%s)b1ooa^3#8S^K#bn3#cH=9s8&@AhkVXgHwEBo zPihnPY)7zjIF_zpo+!`w`Q0L*CJqsJfIUwP`=jOb0IJChiB>%4|4^%Nl;>y`Gr`$| zRCmh7!!n!;A0gkpFExY3Zt|?Dmu&yrRs6{NoYt5=h|C)3`n8z4i4r&;Tr7G2eQlOM z9C`-vZ)dMLB8am_@(#*tajYN=qu;Ri+Z>KJsq7nn@GK=C!MHsY?G{}?M_!Xhw=9@= zfb;Pae2!Y@qE)S2Xrrjh3eDuocA9j~hkkh~G@qBzbJ)uyw`V6xJ^EJWKTeQ@-t_X_6eD4q z)!0#2jU;02p2K;zHuk{6vhJ8VmmKp6p`5Ale4newxaFbftO-TQ?09tENneqRMl|_q zz-u*i^2g~X&vT-SJ^AHBIlt$7dCxQc{2+cFsnFcwH9EpGBa-iDM^}Yr>2QUnkB32K zHcpgR)KUD?!64yXVkN%1QM^m2QS*=o`$IJ@g;Dz^?C0nM^PSv#Wf6O}DxoNHLDgP7sUp=h|*~(m(W51=r zLO+}#{=2`q1)Kk+-&q@#^q_CxmWRx5of{6_&=e@!+Tb|7sr=(yBt5^7uT&-s{ucHa z#4*E`G?bPj^X18QEjrc<$3>oT2+BbY^HtAwQ=qMvKMF5Vqq{MMIz9R`PHrj(cIQjV zZhw3U4ad;ZDcJtUirr!_6C;S(6aS8@_J8X3RR^tT?e8cqwF{+Yj34@Yhr?|J`wL=3 zE;;sM`A30uKK^(`o}iGI*SxhAE0;LQfVd*jt`5MM4LoCJr{MC@9D4jXh{|LKwVN;N ztT12!d3hD7tA(pf2r3Y_CjO{)in!ab3wXjhe8)6LX`#xO$~u2s{J0JGXIqf|h1k_0 zwUiGmkQ$f#5VR!>;V;Q=QrVFDjeNI@1v2@K9~8zgl-ZJkW4u0>u2G9XEx4ZghuDE( z7<-p|x0_aM$aR$IN6B~VOy1l-VHh@^xv?j6n8)5!irW@T{WL%HNejcpS{97EXT`fS zUefVLp=`1Q;4XP~?SCdSi;F&JHI(wFk^(_v>7Czzz6Gje%&KO?^Z*CR^7te6aqLeX zGsm`X3T!*Am~opt%9{CdGLU>LS7M2$lJRE%c}C^QKecC0PCj#@^AFRCZ8SGh)*07>kfTJAz^;>GM3_vq2wOpx;g9@*cq%#s>lLAfeChg-SJ0A0Sk{qB$F6Uo~R zO+gt2J@<1QW{xPsz}5rtrq0ne4e+C=U|-a5{_m(I4sixrF?|+x2DC zmI86!7(k9QpTme0G?-~cp4LsyZz+-i`~C2IAu}u z6F#4xaxi$EqjXGRcECk?WVdB6e2M(NSn6boU8UVn&a}uo8`LBmKIEO+X~p63Dk)Ws zzc(%bk$ag_+>AaI0n}b@Qp+7aZ*!*mVkh^3vU$n4nq@^jos)Q_{+3y3zQ{Wk1_#cE z{4SGs?Cm6PIg|LZ&liCfu50pnyFAN5P#u-5YfvQp>3ev;FboeDreHO%=e6Dra`1DJ zOlr?ertmP>meaS?9FoipA(pkCP2yFr+8L`keRcqOY>aq3???%0Tpju{KwZqR$X0P%2Noh~dfN}JFpW_O{WN4c))d9-G=t$eYdK|eWr2%265)`%fW&}SF9L! z!A(-Ae<{WK^|W0CR`I#gai7%sHD?}}g8pcJ*gY%E z^2F^jhERXw+e}^!{v|In1JI%;pR3LmJYH(WsM|*QKptOuUp@DK&dR4}pfziOT@HsN zk>`4ZiaL@^`l*qBWU0q9ko+d^no6t*(&5fY1G-PiK-?Yjk~SO?dkej_cLt*YvD)9~ zGvPl+q4~ZnN^W#xW+iiMm)&9>aYOQ--r(om}JH9j^ z3-7NNHNtJzC-D!R*~LFtT&p>P-wcZj+O>rnUI#Y1Wmf~_wLKUs6EB>Rw92V zjy$hpA@rs&Ag&MdtjUj?(mF;a2e{$FsSqd>tfh8mVA75v4DTE#gLW&?)tA?80c$>D zB_H^At-ELt|Hi8S`M%XYMqU_kf)Dc*nljYz%)G+9V2chrUm5`Nh7wr!eXK+;gkU#R zptgU^83R5{Brj=SF{YM}mHWqBQE^fT&i*oBR3QD!{=;F&IjQ_ciJMLIsD6=tXTcfx zR8))~H{ztjO!}Su2!=<0^2LfXuyz=0rvpa$o~|UnS%>kw{x>RT;rBnpa{4Don{i5H z#0F!^5+l~HW&KQkWd-U+_B?juEIF7Nea!9HM87BED<7Q=5`4fFxw;TsSWO=Q@(Tv&0bLdnL*V<_-9J|D7~EhQ8j59V6H5Kg03H?N zOp`cyK17LA+d`1@jd{&&Gti1WJCzIdF4^SR^y2&JORc3Bb+F{;J|G|H`Fv`n?gnG; zEFsMeXJP6wixB(NmuqX>@irsn{H-6LA<0J`M>R0 z*Pdn#+iC{+n+Gz`_6u{m1EZwO1to^n55Y3>=Bgjbz>Ryw$bL${$WKaCf2IH5^WTC# zi~(DV5iuuPRv%NM;I9675tTmt*V1vDA4A;|L|!$ZW(1$-a`bv2S)(P?o zml&mJwHtcw4@SEZMqE6ffioV=+$k3$8hX%qwx+k-A@Z!b-xjVcMt?Ou^6rwKs13$A z5Bh#`U)scdV@acU2|cGo@N*sZai5HxlnMLZ)SSJGmrFl5zxzi|Zw?by{>Z?H2gS(h z5hEG%nD6{y3El-#`@A3vYupu@SB;{$-rew}OE9Lok}uUR3%X0iX!s&d&JUpPVMWg8 z%Cm1=kb!^s^_$ey-S15=mF7Cm^Nc7lkoye#*7Eb?CA*_Lx(Bi!-^~8?B@9Iy|;%Q;4rjAw2&*YB3uJTG3mB7nVe)-3~CouRKTG0Lm-b{WN9Eo}`w@}j9N zb7Vddd##;37fwd1*uMm0Ux)!N!^w>bD@NO>SZVu>9JvE}lpRd`{1f?=-2eZZh5f(q z8AlyG*{R|9xQ@9mw)&*a+-)AY#kc*gykwudXR>^9mX-9WR;E(N`uUcmnbWFv+!kFk zSrO}uLYd!D5u7mFP{CH|yv-}z{D@wUi4Do; zCvL6UYmhKzKzq3wL}NC|raCc_#5r_HdNnF8$IG3;CZT7GgnA}Qh0HkS?Zir?W4sjj z()aQ?IjSq;Ww0_v()fJ3{)m&hwpjV1F^X$l@DqFd@M>3A)oa!^9es@#mTaP zhdJjl$@e<(Qr*cYFV4ryA&{$H+YK8lso?LchK)1nZ+Xm%5YCf%&J7(;55>lue~foS z<$EeDq&MT+5c(`CRZw%TJ$Z*3SGK4ybEFE__K~yL)*TL8__eqE*=24>oUFp~`YPP? zP+|U8H?(Z+&N-zTBRZ>bvomq&zACJ`s>DC%)tDtNXI^e9PgW9>K{p7HnW*iJ3!QqG#a zjp)ALhy&aoUxgTPi|hC75ze3Yo8TG348U0Ojn~r0q7}K1QPgxk<2wGyIrMN7{I2r* zJDO0pz6t+KU`}9bdcT(7dFf=tqA=!3ui}|%Pc5jCbCT7>-nSdE)gGciH&LWNuEXSqA%+k`)oA5 zm4%5n>D~CAKG>W+*W1SW>^aZIEA-aUF`uh+HqU`f9B)AX4TntJ9Y?-m{VW`zSHX;> z%&K}!oUJQsv3bm$f6Je(!mJj)P6h5$Ybww~IM_qlbaoa``jjl#!kbAc13el2U1ZNidj6BYHDH^QD6T7|SxdDfZBokhU{}do<0R82yGs2guJXL2 zQYsB8kp1KH<<3HKs-hJr+Qi)3ghKhzRe|N4eLlTN&XuPEmmL)-+kkw-@B(SS^pCVD zpysfQ0&)2YEUZ=_p0zlabXVZgUV7hwhxMFkI{XO01tb4GTg#fp zAFU$%(AnD$Z#@H0+szM4sM&hxOTN`R;@1ZH$hrHocVUhLd-heev>13^i;O$$NBS}= zSIz#l0(}=gYw>0=v89**jH>KUZFV5mc=+QbzxVh_Kg{-|r(skVlrZ+rw=_KLuV7wm}_(t9Y7ehnQWFg}qUjQt~!z9bxpe{l{& zt!r!I4R@%^SN9Ib5n>e`eCbUi8i1rrZdhDB)5u@=+#WMCvzm734;+zG$7E_0J zJQa0`kjXJI7^wk%G8rIiJt<%ydoTd?o71=Z3mh!~oT+4rgEWAC@jm$Ram7Wh?2 z#fHVnoTbq7@dY(#oJSnVO2GsE?xVGt+4PP63ZFT%F0|sYCwT_!Nq-K^Wlc$qXqi0J zNwrZg%o+Py8^+t)P@OZK?~(M2yF(AT4%Ca14={rK3FA|0|AvyI=wd@}eqZ5z`Z(s$ zt8sNM(l>BEzL;JT(d05{tyr8+4>`{4FW2YSb}_Gt|G)23&hkGHAKc<5am~~+d9}N| zCFWJKYco;Rc9#kM%z4=8EHlqJi}hz4S$kY9mzr^&wb5QoL!F5GxXZ+O&1La*2f26G zNdiZbL!9Cw-I6^d#6Ydqs-Jam*w4Dr1Di)N#l%T;wEP)O&;T{ zLbYrf>>{_Gs3knJxf~-0cog$PGTn+~1bK#P@)UzN+F|6)Vq$dE6`m}VM>~ltE~X|i zzF52l*r5sYJx+L#`$#Ti_?SO(rH&o$mgSuP5xI}Yi{;NRu2pg*-qDlsOrs+HtqSCB zDU`&?3hdfU%;>BFowM!mY=8pond6>FTyEOBVlj_UATiM&cTV|X(IkIl#B<$zBR;^j z;a5+KzzO8^9tgl=YL9DiP5AcnhkC6a_SFkO&{JPrObI~mj?BNAOATpc0R4ahP$@%; zUeN)l`N<#ks**4A(H}{-$RYNir-?u3H&*7~O!mjDk>nI}239`OA0v8jojQog@4``%xbW;e&P6{GSKJVe ziR41IzsYP5PyU{#%(fsddgK>zh7PUK(Qtj6*(W=T9v*}k<=V# zS}^Lk1*cA0@W8^1_GD(ey(j0lKfPHhlb^Vg++p%hHhf6IxrWqqt{~3UGzA-PTc8gi z$MG@O+-3_V5Wi@CGX-BcQ=3DLe_#N889S$<{aNa)dvcui?W_q(a-6?r=_(iiWuc6OP=ila#BY(^x2N!g5st}%Jd7fo1|7@JkjFo z>W4OON|1xE=$W|gu#8@2lCgQL<-1ewbw5EI#>Pn=`39B8M$4LR2D!GI`jqwtc}RWC z;cxNMqKQG$dld1$& z@|eEr&E1URH`|twVRUzgrhs2-qC)9nH69z3#8lm}Y>XPqB9+)OQH63<>G^b7 zg&VtA|F57nM$0@1)`w5Y=h#-BoW@bq-5#eW%N`Hr8IZRSsKaXJ25cwCWS4^aMe;kQ z@xR|_^jLRYhmgj4^uHgBP8XOVKu)8527Bi%^i!OzM+m=f3+uf#{NBI!lGmsW1swF~ zJV6I_0B2mbU_@*qw}7GI;rf>e^>>r!INpf;HI2ALEKlLg8nPm1 zZLA%Cw>LsJn>sdfR+5Q*C@W;)W-ZR&KwZnXOq`2hwx(}3UX$ZEH=g{K<jL$eeGIwcoM zw?V~nvb+Mly%accR*S=mK%@=T!ciHBTD(>}SnG|N9)Z%Ec_z$?_+JgSk9>^&ZajnP zrXqA#Dt>XVe_bsVr-<`^I%q-jZ}hC>K6sk-%gU=(^evqSFZvb8y`++}d{_Tf9eFK1dT1@>$ z50cyAc-gQVaBE;M%QJEU10~r`+k2Hjmdxs1pchy&FyKj5D7X8_zpC!X1@LtMQ8a=Hp4^4^9llgGh28esdpX zkKL6y)7eepVPpTfD2h3d{-*!s{=7Mz#W`yhUe~2R5&O-TEi>_ZDzgB_DKy@->@;bG z)VLFe&7Yvq98c#Ao#)G%>n4dU881g_8>LezlSD)%NCmSBE58yKdPDtUDK*w`kN>8*R1`|4rN8#1VMXFvS-J^dL^nJ|g_m;?P}ryOJ6 z{n0Fxuat!!_T1ANDKw*rqdS$g)6C{fzw#=Drud6O(|BUMn7+hIeVa*!li%-2eC2oB zqoS_pj%nNIyHKh*`z$qj>D8F>om$LnJ^KD3zu=P&F(r9@CXv6V)nn*c@<5IdKaDe? zXq5@;29Tq^llb~ka#DDG7Nk%=o}UTZ9OfZxra!KooyNB(uM08x4(ZgtGjlqTcz(<6 zhh<28a%G71e53Dj`Fr#yn|Vya$lY1Zv($rGPbHSC@E5U@o|oORF^4|Ft$9AR=UHS= z?*30b)_&9D=`x-ht~@Wu2Psq~;FgaG!#bJJ=mYr;R%T%LW-nimiQTWWP-Qc-p2)js zM$Scb-mgKY6q*;rP~&*d(mTb7$J%%q*uX>&R+IeMMt=Dqg!Kzb#2jQvl`aGqHk zZ|IA-(w+X4dR+D5tfN#Y5*(>vk09Q1i2Q#I^PGuUqm5tCdS*W;yXB=@6H8IM8Q~BJOd0qIqfr-x#{R!5# za}(-z=zoL$wX?Kn$v(dq=Z;BrBhawzcJy0BA6;uWXpbG$ha(I@FU_}Cu}HQXDYQR~Qg z`S_I)&^%|~Q;EG%TsUl#EHDxaNXuluVz59Rk%~N|U`>B!7caD-2G7*1{cu*(@Nk1c{Z0DX_1%B{EZ}f9mh~R_nchVFP!Orq*r7|))!@|;rN^U5T30I)>20? z(1JDW>25#dz4GDgI^2SdPpL~||5MgG7Zsv-ZalPM=YAW~chSGc+gXw!CJxe18>2o=_3*QX_u_^NVxT*cuax*8@W_ zn`hU~mZ8Y!xslW`6qQ0v=#$0Tcr!ihICuMZrU|PO`H@EbcM7r4;w-F7roV6mH9Uq) zEO?;MSPyak>uaY;;an%0GsYdW6q=AigR}`sko|@1!Dhru7pHhRev7lyInD8Xni^y4 zy5sE~cWkcVj$FPU9p_kA)`p^Ky-?;ogra&w^5LJ+^MmKtn`q*{tnK4IG2=Oby+W=L zA1{+%`H@*xpE-ALN`Ci7`qjRr&u~YDW^sS!UTsupN*<>_>{^B9{b0_ynC-l3xlvqV z$gsD{L*J4f6xaZO6?~% zfpev1bD0BBM~wuYU+X#FQne(9@iM)NI7c>ZqL%F#dr6)b?}o&aXHP$0-YfTA%uISo z{n+0;<4e#FvG;vEUd6d!KW2mLvT!ahi})1JhCI%t`JOuRxzX`nEx1L05eJhLEip*_ z21n$@TcgZ>mmoim)4Rv0!n!YN_;SutEmw_=JX4!K<2gS)6wj9H5xXW7ia0&$Gzvxi zGvwr_QX9}H9&2mH5XLM=a0nfOVUr@jyg7;q23o1n!(+9 zZbd0H0rZbNPCv{4+lOuM+E_mJ`6H%w2It`V(i_)2=`o&i2RcxyhM7;7;W9d7K{=YW^P=>XAzwariIM#}wl`isv zSa|ILT3oA3Zv3efjJ-`hS}8|4M}FCmTtB#!BVN2O1=G7&vDeZ}%6Fq*z-oWgSkB-3 zI2pq_Qu}?=Ri?iFDP0>AyY5B47|%od3dBV1n@IYFKk{L{KT6c0&ex8(?F1Xbt~$%R z%6$Li#xHKlv*S<-7W8Fb^R|)nI>@|WfBNoqW!>L{KFGv}yvWD#X8!5#e#~siB^F-N z!WrVGxR!hv9W-GXC==y!yaR8u%B8H~EYk=7zy32`v)$=f2eUh2ai)WS7)7bUo-QC)Av)Bs1stA#-WsQ_yFq73(S~ zrDXr#G9=v}p{MyA_DVtW8DfF0c%Av&x_E05dvzQ3RJ9=EfE5jgH4sO>{$5w+L{Fsu z^cv=sucZcK3Ui7E(cj`+0M^=v;n$uNbXKvxim?}6twO1$_eWTG7`Ah+5OT!|@0ZTf z;Y@+(ID_%{!+FPM`U&c+n0?npl9v3DMbG`PttD#%)=Fss8$vkt2tFF?>Kc zdQY_A>Nxs@c2&u^!cx zXIBer8=kM1oMdS5A6cGFUhoO>VZ+H6K0+Sxy1G)kOTL&^24Mf)FvR#;Q1U$UreC_s z?p5?RY|XsvN8$K5g*A=06*aaxib>Btwi)jWd+6>JSX&&=!O5FW5_h{$`WyU^et8=% zlw-YEgV%YtvwW%bhrS5DSotap>AzC2G?aN$L!BichBeP?=2MRf!}=A;xUI6{KIeF) ztp)P;H9s67rsG(XdDFs-t8I-%N593^6WA{|p|9%)GprHhlV&!Pbf-c&#`k%sCOtOz zcTE{+MM_Oa$?>NZ|l;nZ6#&As!*zmXr7z6ryo(dFT(xD{P#CFSj@k%4i~|FBFQ)ZRV;eh;5CvpfunAk4of0-})taspOR}p_j=Pd9N`G7iN{4Mxgb=cKVjye{|0<%9>Y$JbGlY*+m-Gd+U`Po-2 zeM`~XfwlkF#(Yl9IcUw{*z3apOfeW}Wvw;#+^3$mj73}^Wopun<{%$WPd8OSCJnnl=9s!TK4^`uaK z*Y`(-F5%dtOu?wSoCS<*BG#S-(wFnjLOv&3JX7&*a}H))s4x2aMe@%mE&ARKhpLMO zJFPibUp-cqhLG>pU5^+Yvuw&zZ%y9fla?mw74M3^L!2HZg(~9K z7xkDCYD66^{SY+@jh$<>+$OK^>kN1pNB^~>#h5)QR?dYIpBSSD(hUf+ke}5< zp?Q-YBhQFce#IrYo=9v9rEugER2$6JzX(CsmDsC3HxtkP(#oB?qM%MlECIp_39mvqIq5%Ydi*GLaIa&`hOYSipHVETE^t zg-i6U3m^xh8GDDj(Ng)F5=kd@*!tZ>4heHC8rkch0H7iPD$m3f;U%#Dp^v`l6->^FQaW&$k6tTRO3FODE zW5y?OFxBv4`ew(<%rz={XX~)vYQSIYCtfO;|LYPb#fM!v_h5!;Z~BM+PDimn^Mcz% zi_cE-@5qrUMXc|ynVIOVQfQjQ#K_dEZV0-fL*QWMhCWZnSl-8r4dO&QN)7)f%y;g{ zzn8e%@Poyebbxu~!&KNDt4HeqBNC3%_cNs!iOOh6;mqf34?gF^jF_-D17FzJ{6${p zg7M7Dj^Z4KzU&{*W@6hD@@?tGv3<5H=DL%QbB=zXnaox1RE#Sxd`I2fOB)XZ?JZ+LcXEXXeIVM2tl7nBQ|qAcA8Cp&rZ?eI@S%*`}MHvV?s;)nbc2GADqR!>Agx^Nz>t@miX5N?kA4L=zT9%1|Lvj z%;6CHv%v@tuHOT#$ZsvfbyPt#Z-u$c8#j3l~~m)bJ~mLCSxZJ&wfb&Bb;A0w|DsbD29 zTUTU20B1OE?G>6>-rq~zlz4PC1QU22jHj3@b4H=5Habp*9VQQv^RK@T7;&x==RIS{ zBW`69!*lYuRtMuwS0k=R(obz^F)^z+F|Jplc%csSi@ilOm}mTlx&KikcI zxB_Qkt(l=iesLf2aLb-n!o7hGn?D+0c*W=3iM^#)yo@}eM6>dI{;Lx+D?xpk#d614TT-RfUN7GMDiNs_bnm#uo zj67m@?w=D3)MYnu!(Zog^x!n0jY~F;9_Mq_I!-EushD}8!}JKg|F@aA^}HB^ro~8a zs}h~u^mtZ=yhZk(o&ognd|{Fh`ZEql=gd#RY@Q_<@FB04?V3Z7R-4?pgbix#!H2Nv@~1n@=u^NXks9m0WFQzIpcE3dtAUZkV5aE|u)q zq>1@P?{FFqGL*g$>+?Z2WE4Fipd4Gf=(;R`+ZCeYS@`*dHge0DqV|{o9|-9oqnY! z9vWrUwHOIl&U@J;R>p@K1)O2mq;JkY z=-->M!yu2Inxu7SgG?iT-;K{iwZ$gc{fzQ4){o7OY2fBRy`s)uB6| zq4lggMmw?gn8cr(9Ezi?6B4-xRjy23stY}J^62Tv+GjHN|2y?~25bt!!w`BMXvs@o z#%$}k{GKFosw4DxvY9x`zd9V?oV!hRYDn)8=lIJ6`|n0f_T}t?^XKwqO{g&0gmauN zk18^u%^oA}uQp=EN6t8Am@xLV36-Oa7+J=IWyI2I8;mG?ZA7zF?&)8R@V>&?bS>ih zZU4)VFd=|AyX`rD$0K6y+!yZdpyy*t`Yc-vnDUKTAe`ekZa2X^hg{002?*&$Uy2D? zu;kHa`yb*e#GHJ-@N5}O{^5D@3>BQAaBbcr9%LFyZ)(n#pCx9X`-cUXa<(Q3D-h(?Yduo9`?u-ZzuCPu0@qVl#Pm-AyiccalYJ zjxyzKQ;DA1OzJ#pCVkVJ%2;~J4cw)a#0qYbe853ErMpQ4xr)_Cc}ViyMpEYledy@f zKCuzAmFUwr`jLxFt*I8-&{95g_FFJhDHZ71U;P1pzpsijh60(wyuiXog>vUyp$u7C zD9(oq1QcLSPJvI< zUbU-Zhq2}W44F=^_TK^6`jh?$d;IAuq{VK>KwN$22a18QbPB!Q$iY(g^~dr%zSu;~ z+_##6aJflOcrWG$4C5@+jkwWaE$m~M8+}ZR9uET0u_b$+x4t+yo3H0X{ClYuuE_zY z8p14&7C~sJ;J=$Q=i#S6&l4>*O5lEXD2G8sC z0}3Xt{hRvRb@X~5URI$ZXT}=lQ&)+=+}-3nZVE>d`^Lx<#N>TAYyX>l@xWAMrdhCk zJ~g!isE;de!PFxbTv|Y^g#A$5Vqy`TV>Ae1wnA_!dNpC@263qc*Xco^qR$ZL8+Pq2 z=w2-q7oS+ryL>9<*yvI4ff~80#IHVB&~Oi5E1NTj4Dzh#A9w2}Ib5YvF@Ja}CT+Fg zb!&Rx7%kK++c3X}4M|IwxluM3AL57=jIp6!Q!7kesngA-*360j?;}0>Ij?v?tS+q` zb;HCUzH+YeVG^;3GW1}&YQ^W7tlnFy>H_Ixrjb*Lo)l+NiUe` za?Xm9Kbe(#(1!cH$YHFRixqqyNyPjwwsn$2J)C7OeWd)!Jv`B&g}f7IS$5b(PM3C; zzIn~$VUm;F)OyHZVi#Smx=1DOX41M0y-jo6WE1@x&o)=eIX`++^m3B9TyJl7GW#>m zN&akblLPnEa&MbbY(w2-<3N?TOi)S8V3jmK;zB)zr(`fU%zvt@crQ>%Qd~9X8hHyfDBH>BEbq_fRboZWBwSzV)m=0Mi1s*hH=3rq9G(hBI?wp_Vy0S_~EX zf9&IjgBIS~{4t#C?Pc`n;J#H zZ9RRi+LNcanmKhT%okh1JZa+2r%RCg*gXQ(Q;9uY41@U&v6{#9fNV zmIaoN^fA>iJFW_I8yfO+5q(ZpSx};t1*N!lQVZw<#r3qzkKEy8VrNCEs5hJ(W3G>Z zlZchJv!Ki0DR5YALH)g{C=q3Wdw*uue6wKN8@^6-D!d? zIoBjT9Os;8e#@j(lrvj#YBO=6w^rDkbMZQWv&cU-^6iOf4PlPwS#o{CIgdO-9*L6t zk=x8{iy`hk%8El-Jn$PDwI#VMWa(^qwfe3hTnE-&8PF1>Bi%NY^ox7%x* z6AH%qc)WbragSXS^Nh?-oq8q2`HZ;|Exn(|$il`k;@2r&X16g)9b=62YGaT}%$)9) z$T@$oL3*-(>Z^;BJ`G|dwca7|R7c6Fs|Kl1+9Y?{Qp*yZD7&$i z>$y{f7xW}qvPp&2iE2z&yJK=3`G(Zm?fsYiX=61Gu2kXc-^`7srlp&j^P2W*w2E}c zNcIzl`co@bxj9;XRw4V63ND=KSS>1SnWl!raL#oy$SWySvR7s%z(*x+^`y3@ggf@n zcE|2jD%AH^Bc(DmFr`EB@EzxLgUCnxOOMDhp~zL~;axWb+T$T;@rT-$F#4mg-#Iaq z{DyuZ zD)s0?o!>;(qyr8y&mxi-NCx{=_WBc9la`yJN2OBn7{)s9;Cmx%>Gb>GMhzr6Cc|0t zJwC>{+-=TQEk=yqKrI>Zt6#myW6U$4BmeDkjed@snT1h>wIA!eQ1UKzzoCY&hY42( z^5Z2l*zOxK^D@01`wl;(_<-_yP#d#h{{^(pkiqVG%hZyDGYlZotM zoWFgf2hG+D%wSD;#GZZGnoKy`i1U>ox3Os*UplU!`iR? zJaQHvXTqa;7TRy1r_EyeS+&c;(eK26`1$U9dZCfy)QdHsmytbj9%r%qzSy=u~8?jnqJ z?SR2<5avC0pU?X~f57_#AJpJ6m9!K{7;~5>tx=Fe9UNYZXEwee-;&i}M za?5*2z+#(3oMvAmg=fig1yU<1QD(dy^{zruAi*d(HxzcS=yN!OvC!uryu86$I%5>q zxL99xon`qBed zq??+^;Ter(MpQGoXZDh(6TGE4y_vEeE72w04l5OQ_-CI2mmJCN#VN4oWiZx$4McnH z^^<0V;Gdejwu8Y~uZ+cvpWKg2#vss#T28IWrwQXE#wn?dcs-%iXnf55_9k_%ZgQp~ zHXjb$-}cmchwsbY!AKqFw`9^<2Q`&p>!_;?FPU-JSDM_=%J)US;?Prxdi9j>twX)P z=?c8|Ag{NJ@upuW=9oe;`B?};9|q%wu|HnC3&C%54E>{HPSVE63*(Y;pip7cwj|73%AsCSN<(haDe^fDifBb&?9ah@_|mPXoF z^^&sZn@SGjfM%BzP){KbGDv~QTMCSr%d_3SB&shA!uHT0e6tHgRdPHTt3wgS>-lzr zj6-%T()+}q&-WN|O)+@4gZkg=EwJ>naMr+rBm62sCd6bjs;#FrZBuC>Wm-r!8a ztPu18=M#1ZA@42cid;gm{v?0*g=mbO!dU^H#g}-0?p=vSi!ckqQW#q@HnbZ-AJaM1 zKVVFHj{KtSCpp+&+nFMZ<4jT*c0m4kM-SogT1<`d#87f6`NPy0mEnnP z5gN``EyB|R&hCck(e9=mRaQmfq(P6G>#2jd)QAbsjrdqdJ=$HYX>OpG!GIhrS(63# z{W+K&mkrZR&iPf!!DF(NLwQYuKafcYQ|fM#$5>oVsq1>0T1|!VvVuIwIC2-24jmBh zEe7V5T8yp4bA{J(x~T^9mU!XGN>3EoQ|piS<;IOj=;yH)a$1jq0M-~jaAxtk2{reU zt88h)-(teDc}9f(q}JCp?s>`_?AgrxdTTbKUuR=*Tcz&u1hODx9(r|F{^yn1=o7WT zcs_rjCcxQt337RKvh1pzB15~R$o6-h*gS(8Qm@E4T-BiYA}zwpdSZjG9^v$qXx&2( z*9m&G9KHw{^XZSt>lmHF&n$y_h^MI2IN1o(8=fT*S$H>!dA%34n>KPUubzXcm9o+Q z0==ZjIehbD4~X@(J*+A2??*ib&Z$ovmn6G4a-LyYlC&R~B4vCNWPiLGsyG!CBQ@m9 zHF!Op_bHVgup{)CwS~MVYcvx!M_|Sw@`JM?K|&W>Ss(v!!Gr;Hvg#5ogkNTCY&6PiayiF$TWs>K6@w`kZFmscf3(*)uM;! z)?|5I$0V+uGORwBcS8;DES$k zsG5uwe2)IAU__XU5vwQWpi3t8$1Y~W$j`282G74q)VtbCZN}{i-5k9_H|w!NclJHK zc*5xa6xmn?P4g1_1|Bj>p^>Sj8q0taYALshXG3E<^sS&o?S(uyZjyg@Q&N{U7-ii< z(Bo1d?$`yR!Kz@?R)%m6kh*%KV=!$@45DhsV8#J@{pC<+cuWR7>yfAKZ^qY?^e{d} z?b`Ylgr20Ho>M+jr{`m=*$TB|KEjzxzFnf0q*fY9FX1k+={{2RsYaIlY$dieb|`mN ziCM=uClG9h;tqCjGBWRC4s^>D0%zt!E>o#x)IJzDFNUI8{aEzC2;Cm2vm=#5qT&GL)=2pbvS3i z9tGjnr5H536ph<=c&=CAoWd`1mdvG2f23a6AG{xBGw_jTeD!4N$-9tm{KJaQF8S2+ z&PQ458tprqk6yd;G3b`JB=2;Q119AlZ zogKD44#ted!Dv)S_Wkc*L#1u~(Ts<& z^ml%nj^N2=>f@NPowESTujk`5&oTdZWb$WP;mEu`(cVq8E!0xM%T>;CCbxO6x4i47 zm6OwKve28J1aXD(d!zz)mhg;kt-z_-!HD}DjLKvgOI`@Z?1Ug{jf5bVx#Eqn)aoC= zdC_z1^E$GI@{Bx17WFiXEYz5w{xb8m5WN{)3+Ovtp6AvA&Ph(>JO_0VO+I5!v@+U`-rQ%r?5u~T4kO{H&$@I!F(PNe8Mmpo;MMku3PmZy4 z4zASB#^F`jD4xN2pS#p6Cx=#_ymI67)I_{S4t_Pgv3QnUS$jaTQ<5e0szFu`CVSp4 zS={odB|r_4jos8Re$pazmj=PPS~&7NwOr9-rVH!R+@JUHdTNZLwjTFqAs^>+n`hV@ zBgT;({2os49WvI7o8+L!$t*lOl8w#W4>$ZGyBE(Go7dB&u2LsO3SGNB?0+02ua}_I z1yHxP-Av}1nhhwVMk8R z^>idEpP=4KiXL+Yns9To3G=s`5SB%KBaIO*r;YTqV~)VRFp4?ADb|l$)z5+TA9_B2 zRp^`&sB1&Ma$*Uk?lsShTzVOgA97G!n16b2;{4omYUj8ZrFFVdLYGp@;0g799JR3T z;E9nnyzuj(7W2DCVxD&-XOqY=I!2=9Yu5G`vF6^!gciI%E<8)WJz=ad-G~Eij2O;- zsoQkwXkN|6*oV|Zyq%3qXKKXrERE&04Ca^d3AKd}D|F`rl)AKS25A+LAPdSE{3W7MGLbmpPt|9!$*^!Bm>(MVCl?SxV-? zME`9oXD573=w8W)UAv8V`J6e>i!5k6Fb1+@q1&NMJUNz)qw5vAV(R1kX6$3CuhhNw zCmTz>nO74H5>9QRd&iQ*UYR0;{0yRbN8Yo$3b?^%cs`lW^=g<#b3WiM`zU|v@yBvr z!!l|e*XB7kM~@fnsh2&Hz1j#P)&`p}@HlmM#_%jQev~*N8@9q#45v)fCYkCyg)iEP{dLEYda+Wm4wF#~K(K(*8 z>Fvl+PtC)Ne;njvI(5yu(u;_-;pOCF8vSj>!dbPYO1WbBHjkbtE6LYHaJKbta({6i za;!7;dY6*>TOEysd(z=Hm9@`QCvjf#OHMrVM>1<%Ef%FCdtDwL`!^tyuE1C7ubm_p zIbsy+xC_Wb=lgOv9YF=zDDk{-;4TgodZyOMEAgqiREp)UD2Z_YI=X(Yoo|CWza0^zrXyy4L_xYQ-T zW^xvfAnF?q4x$b!=dk;yBQBc%u9YeY%d|L5meolSuBDEIM&!=(#++#K&;-DGtCv#?CZXLPfS1h`s0A!{`16$1SKb{Bu zc~=Qm^K)0Rui_sKuRqiABsLexGhF3R5;?LzsYlt9|6Ziy!yMKUFR8?SPk}sb6olyy zH(|-DbnKX!2S+!R94P!LPOAfO7u0J=Nk`7gJXEOXE+xtoN^ONd?o9pHH#{Ait+{yA z*HP?EMG_qvh(#6YQ+z26ZYQ`d`ZbU~-Kj%Y9DqMVqwt#itU;HDm(Y}e|8SW4xY8|_&hiT(xb~=Jnj>bAJ6^I-V81#UH=i zq}3V)qFZy0@oW@^J9F0LBzq*YoaA7AdZdk~Uvoh;{%mSS(P#eN6|U0EL4k%F$V+O- z@tvce^C`}o3xNIGO&EKH9P3|J;A(55A*M)u`fBU0ME6(N&z$?>*Pc3=b=so>c&-<4!xOJQQk1h?wR<}snm88z*l_+{rq;uvYkN(xvWx4!YeC7tik^9(} zU3{O~^d+C|A~S~;ilrub!y#N3hBSmI=r6RZfeiOjpegssYTct?Y|glsJ*J_idNO=c zv3x2Fz*6dUJ|`cl8XR_rA#*`15cWn3lt?r&+MqK@sq>!@!!9<^d!evOONC~K3p<^Xi%>%W;Z zbYp+3Lo)g3=Y^7A*bfiyQLpw|I@Wpd^DWy*R$ecZF)8GQ+tLr+)rO}@O#X|UnmuRvc`h{EmWg2x}UjUL=SEXX^VUQagF20kf-d?jwOZgI~yCnBCFBgT9j080%fj!se#T zt8@3uiT7^ULSI__8u}$X$fTc+LI?6k@$~tfl)n%){pnlXl75NIzh^&Ake@{!m=i`0 zsCyDtdC_0TU7^eQwqIhpXt48F1TI}8k2Z`m6>W6Aw}R;sm0pB zbLzoep*MtMIOe`dL}AxVIPl*)-X}?}w{^$4fC!WwZa~~RYELm9vp4ONT0K?BYY>hG z+mbjtmx(jv%j!n%mx()6X!VRxJI&UH;TTE_lzX}IuvaT3RU*Nwv zi}cBcCAxU|(&1mtbUk*pGGIeA{hsP7bZu{vr&FpC|2qO}_8Q^XlOCeOY&gwz*Mra1 z#hVN1^OXe0Blqy0+-u$M`^1GDaq|3dsJ0|wZZOwNM;q$-n#6jG{8Ap*dp30y-KpEi z^*HT#oSb7{>5V=DRd|2WYh^Dz0sNMTDVOPS+Fqec(NUMgNsSa&J^J%`vvbZwS_!Uq>X7vQ?hd=j;cyDz za~R1U3ik)E5&LDuad*sXMgI2zUnjrQjGSg2a$k#+RT%CYP7hTBd`?nV|B($p3aGa@ zO^y48aJ+j+pIDcBIK{lAXlk5v-Q|W)4I^-W8u{zpnW*yBhUYgDrH@U8auvv*+LExz zmIWN39w}a`=gn$U!0n#5WSvxF?q(YHq^U+T8s--5@dEWHB#F$Z+=X_c7n_l^DMJ#hC;7`CLapH`om{mpH7Rx435x4C0c zFFpP&M-KEvCc195;q!w1lAo#mPkX;-H=YX}vXR)-hJ;N<$+aWrPM;gYR0EcWa9tcP z#<;cd@;hIJmDIhpu}^1LBNHS0aQ`0`C(21G6t#skb7FQXlmRPMx?=?-zG1we6?< zb^SVTn2?%w*xGjRA*a-f*Q@%yN?7YxarG>}mPf)a{NEsoKw8sXH(D zwDtDCl8U(XsY~8oOg(kjcIs1hMZXDadZlK~n43D*u8!Zk35gQLI(nC2lN`!1ileVl z^kfxhFxQ>GJ5JP{OmhELl8hN{l#F_bvT+vuC3YoB)yfI-x@(dgi(tQ*zJr!$31VGm zl;&NN#djt3516|jm}8W?XAM$gC^b$eQg@gvqtYW$j$C8iKFcJ}Es1iwFj07hy1 zBfCx{>iT6_70*s_-2jcDBzhGNGQf{@_y%>2 zaQ=fji}v*4c#}z=yDSuHva!!82i_jph}l9WpEW6a)?9ksqBhU7EX?0bEk@SvCLYR0 zdq?U=uznVICJWalW}!=77J9H|m2f8;f1k_7jePn~kD-5HJI;Ep$U)7g+1M38ZO2Qj z`*FP&GgfOD${s|cY@|4`m$aJmyjMJ=bji9h{5$pIPN~J((_IE=J*4YUSBWa=F2{B? z68Agq@=ryT48H9y8Ry-k-sC1yGKF*MowO2h*IQaU_{i+7&T?`ky(FNL>bIyfH^x;u z%=3_PZ#*S>EqSc59-?&QjNW-?nOmM711Gf-a91TseVK34L*Pq}t8AU?EcJI3%l=ME zBn(mF?SAG*Rp_xmU)y=UN{p+iL{K)_s|Q8$_>%%(l$?q0ZHE)vl=!P8`?D*4%ZI88 z9PXsRg-bp#punDA3o}4u;|6t+v`^ z&j;3nqo`jupI(LEf6I2x%UxI4Ku_CZ`UWsJJ^Pkk zwfD(0szZ>>p7|gT&Y9+gpo4E9CiM!&`y~OeR3_KBH4q_d=~>;4d0(3le5u7c!CKZR z=7r#G$zaUv$UeKCY}L>pI9h|yv0E^zP~T`(2AMAMkKM14Ma*D6QHfeYUYw(!9fOd{ zF_?Zj8a2C6dw_NO%}Zht***pLy%{MujHPsIxo<8@^G?F_moM zLFP)|>47_rKhK|8Uy{9a3mL0!(bR3A4xI!4&OY|MnPjW(M5B#;EOxz%#`$gJwU*G6 zx1j}_zNX{SgLJg9;|#9R0(&P5Ua*dlxrsF|{#h}cS_6|U==I!;CpXfORgN|LRu;Uh zN)3QD)Bq@Hfj{$|*sEqNJWX9DzFz00nXE8*#r9@w7-UA%+vKs*$w{7~FT@ts`NcS;jsjp(i-^P6U15>}KBDIW0S*h{E{Fpr@ z-;!1|KE@f^`(&+tu`WL{AB(?Oagz18E&W)7xk^6kLOxoY$j9upWU1H_pRZvp-;Ycc zdmR&B(`PA`Gnc2VIGREI#}9d!oRNpmeBUd~c}v`7Z~wPe6!)Fv<84nln&B-uNn{=l zddPZepw0+uB#$~Ymdaf;5@x3r{j>)1sJXlB&2Sa%E44gPs-&OZMW&bWlETlfGH9_% zzEY>+Odqwh+~_T5$tpT<4m4#rH6D9;$eQz7sgbIZ;AI*a*UUrm`QK%iddSCDE|N!{ zVBX7y(sS}}$*-h9{a7-?eeHnmWPd9bNv1)8ZuWNMkvKEFp;(^xSE6kfB^I%-w(*Ao zhkn_ljgGpdR{BfNDwK2miljF6xL$I`^7>|*Jbqs+$4bQBFA_l3Xi5oGmc}uvsVl@a!vlbCe(Fe zP_qix#{4DalRllS)jf;i+Wj4c(fpqJ0a56EiCRRT}RBJ~|R(SM>hH6F9fsDIduQ#09vqy|>G?d+{B;JVe3^%%o>mlc{cXCGi)UpQoXxus zes)!#xvAyTeA~SmS3cDz$-!^S+G(k0-`q(ZWE|i2ceXY4sl%=|d)x=51syJR_Vw** zenao&`*olB$gh>6Lc1}WU$)+x=a5$7PH}3(M7MU^N;WuqYwx+XHJY6`TOq1c>W?uc z{0x6rPCHoodE04g8>hAWdqmqa&#tx&t2i^YRn#HB*JX~iIiT2{dU(CH?V)gk%&Tma z;A+VdKExy~FD6Pd=UJ{yFv#HN2GO-MN|z*qbTB7MOU|l}xR@mMPN&HC=p<3SpHps5~MtaVhWYH38AKB=4P{SziqD&H} zjh7cYP154BQS2o}5+@|co`Gt--k`;^^7P2sNZtQ6T3nq%4>;CR8oy*L$KFf>gBEqt z)I3Yn$epRh+j^YWi__58mU`U_)yR(0p!QfTN^PSy*G?_9^wjt;N{w-WYIK~W#!zyO zkH4wW{BJd;vqrFCq82^dYY^wG#dX$B4&2e=UIS`aFyDRkC+A2#$aG{=pSxQm8DGw` zjts|A1$mF~NccC`W5F?MX?aJWHTlIDFV63^rWW@_vMBwj%gFdo$KGCT<{2+4ayF(% z1ib!WjJThgS8Mf%n5BnXFZTaB>d8Duz~`zSEBU*Qwa{bkRO&Mx*JI>l_D(t97Vkrj z<0`#JImdhUXcFcX8Ij>^!v5h#%maIt(}*{nMH$*=X>V zGoLP5xcQv5xt;74j>>_SF=1tU>eh6m?nk>EykZZr_nK_XU(Na4Ls{7HEDPWGbBoOE zF~(&f_s?t;tmjPH9{O6(%)!2;I~FzkT)3YxK366^LyYs6{v+6!YEbSGK z`B_R zV(LVmqt@=9894FCOs@nBtZ&RHQ$+52j}`A0GUk|(kC6uMv(E1@Y?6=oUExg8OCS2q z`p8I!#?t$bCQ?|A8s(??dF@r8MgyMjkv0h-->7=TxtXc-=xjzG<)%Sc!SlDFG6(}5 zV*lemjy|RSpduExgkE8GG3d6J`U~V6dhW6S5!3-DKNHK(&-^wYyPM}@PTV`3983?< zr}@;hrcdT?A30ahM7HnqmE$F~;!&lAemyax=O=0iGfw=;>xx#J zF?t~5&s}5~H_?;(XC4A$tgz!b^OW&gYMCZ-+fO5@qna_lZY({bH8Q?(6KQqK4*NTl zK=YmoOf5k^B~QtHLWzqzL*aBM7zIaysAUj@BWHqOcOn!&EAm>7l3%RMIU~jmop#1x z;xOKy{)|=m88yCTMloaCNqx-FkqMd2-e=WL`Iy9bakPmX>L2u*=Jk~9azuP~8^!eA zBzbuWvU+2pbQxoif3|6HDTSMhn1 zYtN?E>lP#Gmtu~3%7DQ!+<%zAMug-b=`H8jSnn(2oP%oI7cTl|qXRuv4D91;$$jmA zP2VKe4i7w1=$!Q?DVUrhne?LYUU5La9Z8YTtTn!TsfBZh8nz~$DEUImJ`*((_Gn?c zPA%MYJ^b3~(QiI^bS1Tu@DW5BxW=t z(9F5SN36e&Am>>?y}w=5Y$BU-{#-UZ=2L&G!vAPjmj6O#a5PzvKa{$~yGpxyS&uEg5X$NH8IHP>osKvUb{G3{9FtDix z!zc1tI_ZhAw|OS=Je5}D|A+DUabZ2OVkD|nHo@(S0j@l=7Vxa=Jd*4w>yCSGv3}e# z8}gKXFRjT~vaY_fn6=jea-M!lT`%5~W$ZWHeyPx1jvyQIAVq@mIa6`VAPu|{ru z7S}V#(Iig<*7L;OI%GgfYyO+Hc*FUL^}dmqIgwhCWypfCRy(_WBsD$A6ZJNt+Bb5H z@9A@K(TI@yoF{EzK(AP`o};N5*_J$PXf~?G(bp=GXBvAC7jG+c3C9(>r@IuoL*!GM zA7kId!$)R5X(Fj*wbEt0yIl5D%dopz@##Qsh9D)9La7ZqU4gkt%!e-9q4uH>bovqu z%O3hnGdKB?7l?OX={MgZmYy5ToyU@aKg@i%S`4-~i$S%O7R+BkKF`mBxBV=b=$(O4 zjGgB`rEY&XHTAC2Q~7}v?F#bn_6`|lRTJsi$y2&5p?C4OhEiOynY4bamTGAV&JHT! z(%KHeDm&=EQY&^IzxsrrpluLzk-^Al9E@tELg)(-f?lIy@q9ZOIeiS~ZeyO_F9r_G zLvDF8R=4L_I@f~7x$KcvAm8|iJ_e&XdsN{aDl!&7NKR!sWAv}TxDP#UBGaa6#BHjN z_>O2QV;47-sdc<$9rMIv=k3sBA$iZw3QXp;%rq%cp+*S)>=c4B$ejPlnaDT``nSwLNAh|~iy7msX4E*!UTacKQ)qoZeD`Iy9A6Hg6f0z=&!ewxs$I2&s{C_=_cDU zE*&1f%y@i19~+Hi&6$f_TxLb|Cu&add@W&WEQN2I%8m+6_v#j`+)0n}rsP`MvSu=j{?5l)H}PQ}<;48TpL1Q^`FSOg|7?Nsa-61)b zt-)YlEry=(M0axL_XaUH8KcF>x{+|}7m3k}^wcDY#4I)Q3~KH9XiUgGY`|uoUDtaU z$;TSex`YYCCekl>Q4Yq>qDJkyY?Qph`1w^9URv0jB!AYQeC4Cf3S9-BUp0AclP^)1 z;2!J!w^Bq;&4QV)k|ld)q70r*KCdfl_;0n;vDd)<2=yyhd!kN2BtirADE*kT0lZf; z_tN8tXRGOy2~GN$P=e=asLF^*oX0xUh+51wb5Nok=hK^$!GFaW_HyLC9ka2C=lY61 zN?qj#yhrTUp5t{rJH)ef1^X9&9+&Q($uh5bvZOm6kiRP?%OV$Y_=i2A;yHTvff{X? zE4E&)hT?rB%#WBiH6#zPPLG?5sEbi85_|KEoCh#rO;Z!n9GEw$O|a)a4W8#q|H#4J z1fCmxIZMxLIcFwYKwt2O6BW8+pU5%tdPeeG-ORJTU;07Wnv)_O{^7M07^P{@A?a4> zptKsPMcz6sRxbAh`E%@~w#U6_>i^7)1o->)Tgbmh=@C*Kfol~a5vif3KI`+sGkx$g z*8680FiuIm#vfT2{)Rox<2)&R<4F^^gxs};K5E=pbZs!E+l zqZH}1DMi+@KhtJhvQ%<7C_eM4VcFOV9||;BK2eP)%h(rTPF#3Zi~71qZ2ihU#9;D_ z_w~s0ibSW9WI%6_W#m_@sYcwZM9qYs)O5-wV|hA@n(^7_(lZ;Sj%UHpCmYuD^iR63 z(0%bx>Q=icbsfk(jG4)M^yYtg#w%ayNSR%~sj>o$)MlpD9(NNbP;{O?~*#sA9F5jf~hn0!dm8{;tWTbev7

YmD()?v zsCQP+O=^#_Nv-g}|E|YrnHeW^R%+xs$&Z)C^2M-Zr&P% z_4ZN7vu7Suhx2ttm6+C1ACUerKd2w@DUbU&&sc38M_E0*Sh7lUE+Q@p_nUKHAJ19f zM~+giE;+%M%tL!}{`o>0JT~MZlfL1j-~X0HJl{i)lP_P-d4J|n`HkpHTlu%#b)?^u z%fJ3eX8NwMp8c|(jAlRNqcBe4zO8M@dfrYe@}!3B9c`0aEBxU(oxa|UIVZ^a*{|V_ za+&&-)#&3~h5dmFXVS3ud@iPCIZLNszr^uHKinr*mGe9eOEdGRSI|h_S1yoB+xa|n ziNUv=G^nEU=zr)aP6-9_!zB&a{KkF9nD&>t@fnH%Waz}jfd zB4=3>SRid8g0S}x`CQgePVx*M96N_2Z1ZV;(9l zQOQ}K0y$HWwfoYnYx||+&QtpEgw~c$zl){Y*+8h{3p98xS%X4djq zAMduBTH@WTXtuyv_PnF-6YsMtbp<+BV4eCO&cV-cmg7CBsgT_dGx>aeUSmd5bu0eL zX(;oX707(&fdAqt`=!)NP0Yig$_>Q((=Qn~ED%$<|Fr9yj9Q$*je%pTvF^_rs1Q>dS>OMe@87eWX6HA66zEFFIIJ zrH+fNx3@_cHBFZGpti_l_MevJaaPth)zu#_tkgicOT*vESO(r3A-zTaJv_ZNvLy{j%CjlzU_^tGQ) zzxclH62pDqoHhXC8Migyy1T)i(+cYF7A5}{Reyg>8cn^|_US0~Fb@aw>Pyj~U-Fjc z#nFB2_XY6!7x7&9?I;y^f0~27RCS`D;Qcvs=U@KXP3}ziDdkwVyO_U;v$pA|b|V*u zvZ_gjC%yCb2Elo66t3+eAI)51a1&2?Q^h9J&Hfn4{p93e>S@O3;k40F9vmr@yHNqS zNL|Y$k97F(dF%c@PNr4xzoF*SJXcTZua&ob?6q^2uOc~3->URFqW=dQ$$v~; zIdcTsdK>WZHFfch(qH)fe)*>JK-~%9=-k(UmCNp7eiMbR(~vm1Qd^C3`4OlwkN+;l zq1%TjblHq~M+d5Lxf5&ToOcP>k%ff@8#VO|QaMz| z9|Pmbzp4ASEE8>ObDqN?PPVjD;W4?t=>rUyRGsk}x!2IQ31VL2&g&#M>R`YN2iB?U zFh*LRAQ`^yWKF_wu|EBjSl=4ci8HZ%ljLke`utYr_1sKCBR(hX7*}mii)VTUiFNk;> z22;oIc};iR_YOy3EIGLEnaK2_w)VRO*+D+Bn7xf|JIGbd$-?pZHdLsZC}XR8a6Xbe z<}~VS4Wtjp2pc_ac8eRYC!7A%fAMpyx*&`3t&N^M@v=Rd9M;QlY~%ay*g)>DD|HFq zB}#3O`wNahGC!~N@tLd>D0J1!>=(QD?&!8rxbUtt*hnd^El zH5yJ+FY@U=@eLw3s#%C`Kd8T%Nqt6gWcso3QmZX>)ySh=c*W;oC3W3bvfdVHl=?s1 z@yFYR*!IzY3(kz)In&$yd7|WpyTPqqI8L5SLio>2`d8YJRf+W`YH-}09*)thsclp7 z``yS1_Kp{u8+p&x;mE3Nz={|?|GVg;O`XsguRP$KrALV|Nw^Z6g^XqjorhPvRJ+9) z;F_GVok@OnF1eX8)Pbd6ZVr91FMXpQtv&TsKXYGlA^*EDPG0( z-MJ*hC1>K>ZStq&tY?o>qduS8)~?jRXim+F*ETXq@zQRD8Wc%^V*?|qRLVlt6i-*^L^M)O)R$gt}o_aC~M%-*K!}$8aBr;y&4#UIBa_g1Db#fV}5W zdbu?V$H&9;dEY}_*Y*nC&p`6v%;o-2UvI*3?;> z&ZnYR@|l@YyZt8Wccli8m$QF8oYlJDi598GV@YR=N7qSRnOq@lS@{ZSOP)uhmfl#o z-MmBgX~E%*QxneUQa87|bGB*5tJICft5eN4;-s^I?DhRbd9lMFx!p{%WiHQ9^5iGz zg|s{@UTW(T<-l5loa4RvOjhyaKZ){MMLp%elcY1(+3JQ#GLk+I$7Y&jZv(#0vnTCD zqMSZQEgsG(j-z)+V!ly2p5bS6$|(Nf>~nLy9U%KVoqS`drSY=#6uH~J2Kl{`{?fi` zJpPM*9`uKf{acM{Rp`f1mVaKLX9R0E4Jv7|HJrYHKlnKx<{8TU;vCP?s?)S^DZ_eq zX%+T&QseA(a{j$Jd&ru68`f6hm(W+7v;CO^RQUOWULpOc=hL2=rvLW2tEf>rNke@m zYS_->xjB~FJ_%YxUyMLdNj-c9kT)bdKBxlgLS&WaeT~4TB5LEz)?>?KKFd!c;K}+? z!5jJx(wn-|4m~|_ijqn=PJ)IhK2N8AIs@ANKb&sxo{f%G6e!}nmndc4Vi znR5*AzQW$a1MbIj4LH=oh~>MTRG6xi1H&1Xj7khkBoCp1agmN zZ=h`m&$vff=&7Mspp|Um^=$N+$9h!lY|cor{-R<{i2ID=6MDV#9GicFy{OzwbYk7Z z&@>xiWY@p4Z+%0Th1mY|ldhkQ_`n=`xR77W%0ef;=QYN2-~J+VzlZz4bZYgme`GC_ zg&H%c#~hGNeNK0AadMWb%p1v z@U;}Vs_8cQP1dk~k7D`mset~iO&sitq)A1aINr8NqjpLhu0{`{k4jvfT`V0rA7omg zfUluQwptXZN?p3OWVCd%ZF1>ck#smyELEr4q~Aem5bUJhBQ+i49~R2(Z06S`ilxL1 z1xf@2;kt7W+;32igUc!eU(p4=ky49&_w&Y6>? z+C)tta)<{U>4DTL5Zgxvq0}CKyj>WK5!-?=f&63h?E#qQ5rlxGAcO@|KWIS!u6Cm~ zgnuyZ#dC)2GUv<2(igE$AWq#2M!k5>Dn5&ZGc=g;ftjpP!8k9DGPmo}RuIVtt91(%*N4?9bSYFawf7tQ3DE$H}(9?_Gi+j!WFUN_TGWj||O-OL!# z(E?e{x_O|5^9Ss|kmI^Gk=jVi?VbBrFyx^btAd%IZ!u#jxvl!=%xKq+HTMnt{mHBo zT`}W+Kt9%ZQ451?VfF=jSp_k-(y(68o|JtYr!PFZoOfOEG) z=wW-sifQ%PXP%Rfm4DEWt1fkYSVMWoo<`h|d>lK+?`8ja@HqDDCsN1p2=m2hdGO0( z-HrW*Q?uDC3L{I&Jl?J}dsf5wy?V|OH_%9rnp#OM^yci6i###7Nyfn@^2ndHw4SbH zGgtthIz=(2ydDElHTkeG%_R{~KmgtNflTx+*L==pvtGJ`Q^1--TC5C5I-d-^9i$TWY9xJn*D z6$Hn7tEgkD@P^X}0jtueiACQ$Em0%z3g#9)%JM$?*n z;~LJs^Yv@p$vpmw#-Nt$X&#Sej>fg-5QDVMTuUvZP;&`;jI8&Zs}+OHsA%+F5RF~; zspEKq>+vT2s})>Jf78DrJqj0nxn}?3`&;;4L#YY5G8%6d@oRkyUbE-tbT1v9UU6QO zeXa?I%&0kzHP`X1-&Upnmmi;fOFCw7-CZ7K#>j5`Z+?&V5q*eQJBk}?#=L*1hZ?{& zWae5)QAhBb3JuGZ^7v2W(;V}+T9ZR zX7J}%th3^08Tv@OkyW{u$KDoaRX6A3RGO9gdR9ChNbjJ-oSRL~!--tJ#&w|FX+?G) zu93H_-zco8^pM&ocex&oc`!%kK||iL&3nF{L)}x>=KJ2WVu6Y^`kC~7=Q>@-9@=;{ z*VT0XZmz)%d=KIGT`a-+;I55+e|TL=T~rv5`d6jhslQU1rJX%!NPV#GM`}djnYIl| z9P*o+`21{}@PO12y=$ip*xKCBwxYt>f@h0U$CS!Xb(&-H)A%Kwo!Iku>dxB7&jyxh zm-=ORg|m?_Yp1?hKGg4ajmxQ*8e3B>2NTZ>DqNH5e$zSi&5P92UoX{6J+$uR8HYy~ zQ=1)JmHJ4TnA&dk@>JJViSnRsyp-LRB=4rA$R$mZEObkj=m{oSeLYFGO-Yp5oMXAm z`6ZvtCh^^6kfIYQvTe0Ne*9pZ*WD;jbxAUONwU=D+)MDiB$>F~Bp?1TNo+fVOkq42 z{DAD@PtM8B+%Ny!FvyKgDKgI9C~Ho{N!f%r33D(?vexJEy{m)hdKBmYlat zi?2P@7%`p9VWUXuD6yX@k+}LNJ*L%UDjsq!>xdpxDpQZ-oSt009&aK!>(`guB6G%q zkKuUKhqI&nT0`ypG4u5Z+rk-{CX6@7k)6>pE@VyW>oz@lPG&8Lap#0ZoH_i9IvMut zE1inKknZ8A?99CMdj!Uh(xc=zJvK5{yE%n%UJz%+T9Z+nK`(~o2E5zHoPPs#{udkY zX^0W_teJh`|NAhBUK6)imnunZ?qVZidm2#gG1;LV?7uqGTlFDxpI=EhIn;nhlc-5n zjoge6c^NOpjBUvAv^QeJaU=H4rKb05GAyIWP;w45q^=30x^SlER3V6F7j7vJb)y`#Ocf}kuWe-^OJ{yZxk=Yrag}v@%8GRXZ?&MrDzwh&GYCp2(7PT}R zYpVS(&*+rZM2?s95<8`*$a^md+v_RUuer*+7u4%5vO`2KC9X7MPoL+5KPbo@pEG@W9oN_6O>z$Y&|4DF%7k(UbS*zZ}u7*91R7`p;P(QO%Z zzqc^X+epviwLA;RwLe`HgCuXpdNpFPmG@)`W2YxyEl6`BtIj>U*$48TudImI#KHAL*A%h!((C8TIB=J6dXAH=*YgH9$bN}RZRJ6ePx&<4y zSm3k7Lj4PBS_WG&Wp_R`$r&Skrx#@?*-sny>e*UqANWZ239Zbj=_U6bXr;*kl{9{? zKqIm{Hpdc}c1nRE6Y2YEQvj7i@a7pgkS~m{BZJ7h1z~9WAoi%JKNb`XpJCJ_9~^@x z^QZxKJ{o(;TU66q;C{x!Ib{nzE~iewo(#?hSz+Ik{Od_F@#F{}^6QFFx4U{%aqg#; zK{YhuKGs{thBOfeeG@sBqr`wMHc7g{I3}L+Q&3`slA3KTL!qf1f(=(g@bq>Fo^PVh zD*2Q(EqM(WqH%#|_~)~HuA5R<^I8nvwzNCufd(Is#u0b6>ndKjmHQopUd_zMDF*%wMm@G3VsIvzqJQ*C!iwD^bhU zm<4CDgH7GJAFO2!iwu~G+{1L0Qm1;Q(6u^2O`v^=(!DTQI@U;*FO!nxL)Qd(RyA3o zR%mf?odzd*(1$XH^TXfNxW$@+tpoS*R@B?#p4#nI1m3RFV|+dOJTs4;!@PI6)rg0; zjCd4hfW89#7T-{Bwnh$CU1J_fjiRK6IVhZ(gBGl@j#!}3Js=l%y{AG~{(wT)fDFWv z(?;3oo-7XnO!U4;lI|~!obNHpiCe5IueliUiTmvC2lPxxr+$M6_whC4EvHf+l8j73bPl}_$$7qKz4~89gxZj= zv`XFoA?>XHn%=|rKd?nTc1uZaAS!m=*Ywy)46(brj|yyd7YqYiscqPCPzJ;9B*h9rJ-n`=#*ZsV&Yobn}wp+{NA>VkGeojI3Zi-4dD#@FUOJ`?# zY0__bGquUTzEcCK=7(M*e395u1zc1jfyd~#^)`Z(tv$5Neo|>9$EIvk_@eq3*$)PSHAJd1&l0mLA+Q9QvpimED zUE^8fgR)3_P%PDtNay^6ayP&r;gKfk+n4^8&MK%mFHeFm+M9i#AU|kNE#@ZA%dj@g zSgrFPTeKK`pXd;?%!pMNn9oC&sN_f!sx@X$_Xp}3``LrJkp5rCv#{j`^BxXo;bsss zVE3?wF@*ib6Hv_ywmF*>Z;szo2(&)a?JS$UPYH1`Z(Lm>)U8Bwx<2~+R! zST2%h8cp4!b2bc*v)G%(xow3){i#r))|27+*w{|}Umo@;EA`kZesb&!*}*c6Wpk>Z zGqCH$cTUld&!2UZv`}J2?F-!3QDJ}B=a(nI5 ztw`s-u;;2KQm&w>-QwwxH5U?$0^)Oy+!A z?0Xi&1L$?k_4JT=R-Boe2ft-`P<>*qz?A0F?RaCUy3|ivw`nA6k{gM>4fl&niey~{ zd(H_Ydi8iDfDK1P9C57*ML@j61U4=9t1IKq?(s}=;be$tjs6Zm0-WIJpyvczqe4J zZf6B1Ut(Tga0r@r8i4YvIkz4gfN0KPWjJ@0;yF5-6ph9gqY;+JJ)V_(rHS{9g5H&1 zd98RXW!F$6$)bkRi1*4CzW!mx^DX+;f6BuX){Ad9^pm2h)YxYEv##4(^!uAg0<+7X zc2uC^Z+lF<%(?54O@`g02b~J?P1Lh8)-l5Ax_?YK%xC`YVfGI#Hlm7+zURRlZ!*cdKc|mf3K_z$SYdJ)MP>iCm*^=lGYVP=97k#Kt=JCe9a|`Y6=Noeffv$Mn*cBn?j*#hJb+ z{hB0*XANIWui=9+y?o%sIc&0uwLJC;oKTVToU6mN`Si1S!Trq{Ejkvl*Xtm2hB&9L zF&UXFVnV4YMi|*o8*jL0d*|kZ-+Q(6J|^o) zrZU-6hYsuM({Yw_8TUSCukuyNgwUZzJUdU`vyKS|i?h(>X*N=`>Hq$g=f^o4Bj_<4 z#2y6&y$5qYDb$a79Nk&-oIaEF(@ROB4l_yc6qD5NktFXu5@fVBQLHCaa4F%7Ps3C= zdC(i9S*u#W<7xc24q>c4KAxe)u?jkLIiSN$;asmaBAxTY;ua>;qAjyky-A^bI^o4(_3|#2fxdOfTx)8}t~)|5dQ#I`(q&kYESVJq zrwMulHl&WVf*e+|m)O%!t@vC3jL#zx`Z5isQ1;NqdCNQc7o@deC;XQvbZwf3xX2u& zvS)i-r$Tw$I0$hQBXQ?+8ro5({aB;EZA(nTf+BO z(Id{@g7|^tyzV+nRYShinIC|?)0nr*{Z>dr@_L;eW$O*j$=k`t>GTMvu6>w&y!%hM z$>C1L^2s3xXUXrh38haTkMqD*H>t{`f;!Kc&-*441tH{{YUjdbBY9GfVsY3IfC+yh zq3=b%vx(dj40e$rDfC~vK%Q$l^?AosdJd8MEAJ$chl^!S=>S}cibTw_G^jez2aUdR z@9x?p&@Kpd9z@d1o%znmIXHi+j@)})Am;o)OuiO{>LrPSjmh1V6CFW%_t14!=A%GIq*JS zS9*Uhl!H}*FuERfP-QBr&&!4WKm#dJxZM*%->FbaY!ATQ zz4UP#or(kGo67BQkr~r|%eY~I%nyyktvqtIE>^^sY$$iR`NN!L-k;QnfAcu6lk+;)lU!I!)|dJ*|9x;Y&IG2hN1MN|+C`$X3#1C`Ife*5 zQm3)jQ8fo{dQT}isZj0=WR1v`eVj*A(d|(V-mGsZH3$EZBJzy>J);rZCk@q?TCuOS ztJL88uQjD##&~jY+BC!mbG@XaU+2j}X*`|%{sW@$F)xdPkk}C z&`)p`bD4{IpL8S7>tw}(AQySXdcunmfq4Hl63+jm(l}%~=63SB}Df5%k62eOP~LU3p!eHAME_czNmJ(2KltW-fLzn{MiX zLb3D=#LWAVcuIaSX=yH^f?cKb>>_E)^V4)kBnB>`SHRv}9Qy7gLwXiSZRXlPnHt56 zUJG1va}ev_K;EkJ>h?%8@%kz9NkgugkSn3r2{X{;4N%j-!w zub*;qUm$y!cwIRD7$@bRR)&-8cwZn-j|L(lKN77uzSXHm9&@0RY+q0yD);`F!~5Bn zI2C%!2FW1Hy_(wKcH?Q=2jo|}BGT_{^Q9*+7Qg=ys9C-=0X!V^bX zB}H;!N-*?lJ@(w9zvKscd&IcP{MLmsa+wAp+~*d9f8fLiOY zPShqn=>NYYR#sX)5qc^d!?qj9<7ePc2^)GHPn0{2y)dSh7Dp=@(25#rW_hkJj>gLP zY2NH%(IQPl4I=p-zENjbdMsXguO}~dAsn^bm?yiHHTB;%eA<0LvZl}<&^-(VLkx(h zNlk#<+`MiH;xIu8*Nya4I+cjeg`PHa!z3yllwcNxrGK zH@V7ibe&2^auRN?1bxFH;gVB4!4E|Ox>P=&E$QKw`blbk8@~fIPUFEr$bDftj-Wxs|wj}oBhm5Gn{ZTQpDAWc_$LA_!jMm0}_zdieu z`1@{t7AM1=ctZ0}7|gkeNDU%~#WieS&p4^H#T)8~FwDQrwN(xJJ4M)#Vt+sa$*=TI z=jXeS53P^|T{{~hYRAgj=k)mUjKF}U?4{jKU$z2ri|W1NQAl>CT{vWFBK9B8z@{_2 zjyGc^_q`Vszr(TjFmshWGLYoN{-`AKn0haiIu-%Lzx0pu&A^mK=vjyyv$>#MzMt*=EDpReUa3lQAs`XI@((ibrRn(2qQGoc?89;5 z`I3HoO~cTbY)oO74D_8+40A@TY;WL+%-X!qH`2o^g`66B)v|8!vNDfr^0xE`Oh|-< z&z-|w8%F+&m-t9>ZRA+zyBd%>j``qydES1LcdO%#bT@v^3i>~+&t$JVeI!f9OPQtK z7{U8L@09_22eIZcnLOi2=8U}Z!pFy2G~n7<(#ePB*_fl4Am?6t)3-PbickZ#^FG;< zU5vl##>vmN%n=^L>*a4CYmk8k4fuSGjuW@N?4hG?MK$i1dK6{gW1K?0@egyT-+IEo zWCXso`X65P4fV5g%6MrO#{KDe@~wQXCppu{@P`fE=fujdsh)6h;n!WMgVoK%tcy0J zohHYs@xteh;TZXg=jU?8<$I9Xa(|-<(|!?edXn@H!;c+_c86z0mSU7`mDh zFy}peWBL0ACLWLlJyH!ovGOxy^vWW6Y!H_&lLRtZbRB!gF&NlFlSz!5sEh^Y=Xfex2j$WqU1rjwIs! z;tb3mXG4Qk`=so2Z%j#E1hbC3dEz~+-)cj7_FGRV=>^kt_Qg3F5PBs8vp9~q1;@!+ z^0_fSVW>2M{-Gt^g7&p9EHnFQ8k!GWsbG$|KA`>GuQ$z=HEqrA#~+(Fj#Z?l zSH7PT+~=OztA)PZICa~$v8+D_T}~2(Z@fI9*XA*Yc=`K>K^_h<%7i?6)skm_Lft=^ z++m&GCb7>kO7&_6={3S6>qaI@cIN}qw4p)1QE$#`pCp|)UVX@nmr_9ODg=w6|d#1E_rR! zJ}(4xP~yf!W>|!hIpnkTbD5Gg6mLwvtwO;DZ``TRoQ;Y6dosNQwyVhSDAD(V7Ybi7 zha;U?^fmchM|$IwFYDN!nbkg%`P7^v$bTxw03(Lj=OL5qJ|8 zj`QauFq-e*RUF0)l5q5CqlKPY#bs(bYaHqS;KZJYG%cFfCeN6|p3I6`Y?=@O)e`FQ z&9%%LjlkdT)LO3b*o|9d#HhRx5=w>08>Cw@;JJ$#z5 z4|J;$F4UIp45ok2ZTc|QXAa>idhb*>;wa}c3pJk+S6JKGNxo1=uf#f;7+ai)W3{s| zZwUQ%qRGEUWTL$y3lAP;V)_a4($qVq24pf1Gy``zE;grTcJ@yeMx4*Ywk=uMJBmI& ze9lHk(yO2;GpoyzmE<_K?*=`psq^=3nT513?8|7voNE4DJ=Z$b=VxP~ne}Ye!XNNe z_M(^Eoz+O{wDlC*W>0Z==OyLlHI!BKR(v=_C2`d~<$=4mI5zNJfDB23e?42OX7-EyYo;KM$fs9s-5?Dm@~2n zkUbo(p}$!mZU>QF{H#G@ELo@_!SLA|f`6!yn7xCcoE(V37lW{JIr&BZVBAR!#`|{~ zGT%XXdY=2g-}H*}<=3e>4H*y&$1&WK`wqasO2Ig-)u77kAl&F54C8Fp+tooR=*r$l zezxo9Kn$S%u;yzpT&J>Ub~?EyYT&&tvVZV8`KOuDFf5Kj&&7H?urc@cb`<7QYx(98 zjmQvY8nAzF!AE)m^dO&DL603H^ypS28vXn0aV<3(tLt+A%vwlv7CFXeQ8;j)-gJK4 zn^$EGULpeD;BjOT#~PSs!R=LDS@PbZljT zV|Uh4zNW!h!`uW{{<|r2C#G94JKchDr7dXtFb%)S2rR3bj=!nfkG-FUO<`%w^Ja}9 zkUZ6C3+5^;P@cEoLlgQ-tmpSgI;tt?y|dT?EKkF#GU>S4n*ZO7dDTT0d@h#`rz%zy zIa;Y*Fz0qAGie=j@un?37u&P$|1%dO`}5ze@^IlOGp-7Av94_%iU*R5s%k}_DfEe$ zMlZR8+=o-^3dx|(lWfIZ9s2{PGG}QRYvNt_*-fli!oA-%pFHe*$?qL%MJC^0KbyHJ zW32e|iFz16yFb~h_&8q)Y|UQ2jt%A487JxC!`$aeO=No~Z>enWEk`!Ao zwJo{C+VnkL)=0um`bzJ;Zt~%(Cws0{vZ=JUc=qy?e@`l<4msf8$Gl`}inn;>(U;NJ zM}l?k^4io$`k(TWH(%W(!LgCNa%d<{yWHg`nacA&J!Matr;OXlEXCh;X!zu}e5t6w z#977iJirbgKGE#j5XR9fD8Jm#hm`xrrRF5CCqF|k& zN4a)-s1xbQXwp+xV*mFsJw_g)r&dE|nRTT;@_^6Zh$z$ypvUQRX2AbVCNhn@1+}hI z_IeEDb5z_>j{$uCa_>YzrDV^%AL~f@Q8>|@d2w_3o<6KivQFCRPZVn}Y1mxKg2s*L zn@G*1QAZ2Bs6pY&?UZh(%+O^M}9pEN?c_7wI0s!F*nhr^%nI2IpX+33LUMr%R@5MmnAI&08#Y;CT)?{Nw_Ma_ zrkr18GQ@q!0wpmwBPEwTtK^FLeNSGpFO)U9QKPKf_w$+gNKUx971>5B8c^f)A7{l* zYYyD`49>kupH+U=u;saU+LD~ijtk~Ky8S6PdOc2=5KuF9^wgK;OS$D!t4@B@u5G(K z^Q{#+bN{r?Z!D%IN^`FbR!WywwLH22Dz4-bD~Zdqr!`NgBc_F;PWRKFVu=4TJroVmC1in+c2 zUUT?sm3igbShMSuz9~o8k22HFC}ZeHf1bT6ovN^|SI;OT*-uwgoG9aR;$_&BM7iy0 zloNC5k@2@drteOYmiyx6NP4`)@ckLguE@+Z$<{sxWixwRX1FIx$V>8yiShEvKT&eL z*-IHi??&cH7k6OK3wx4u^o1;IHb|YMIB~s@ApPj$UDPQ_hFv9}I9Q1jTpM1=@kXP@ zN^H5WqPG_Fr`xMAg?xdJ9W%~4d&8gX!`O5$^y;NV@=x|waZPzQ&>J4JnG?5*zKpE9 z{e8(3XA`{fG29zD551A5Q^LLxb%amcE0{ddE`c5zcI0mgRY*%xLRE<#{xiH$ae)uk zo$$q4XV!emYf+^){TAur|9q(y+WA`iOpU;#2-c@sN1$~Ed#miYetgd!I_~eC&uQ`Z zYYRwc;8I%bCD-FnAsl+HJB#dfm>Czr-&Y6y6)j48(3|lY^8nZf z^J8x~Vz~yLv5PgY&)i$HR(Y3u-Otnl7PesB^l2hC3^u}(Y~%E629)AnH0K`!YP?|P zG}n*i$OkoHUCMtAwX+S(k>*;jQ3E6D=?&=a$3MFoaq$rMqcGtg>H?NMXGgnD=;@;Z?%Oy_!V z2zyeJGcn24)MmO5Bd5rqfq4}@ z`8@+zyKBqrjZO69&nKh9I+`anyHl)pqDvN1`Tu#@TqEw!L`EF7v!z+6bSVq}p3Q>Y zqW|R?OPW=Z{?t)+{Od24pr+E%$5Y-;Z6qtnt$(2xud}@Zr`Fmb`lbR~`EQ?cAvk(2 z7%}v3+Bz}>#o_eUyUyI;wb4KVS?|ZJEo_QL^-^TNa>%H0{PD<4$DB%M(TC&F?fMox zX3s*m=T;Q3mLE7H5B`JbdtkM~Og3cGmqy~3+d|eIqqp~AAGt<8#MZHi)ELLC>vsx_ z+^@ic$IK1QwaLc?3S8xU683;z7$=y!!{howKkP-zHO%Uy*FwE5C~+(rt#;`V97-mw zEc2!(S}^_uGtB-?N2T8uOrMaBHT0Ky8JmY5$8*szn7kgxAN$Q@t~o|^%IhHSlYQm( zEqW<$Yb4z^vMv(tCp|uK{!38cS${jsa3W*5(;tpmU4{6X$E_F|C2NfWF>d zJWo@$Fw2@AgeS?x4@jqdJfr?@l*_B}2Bl}Q~ylFG85%->AMtI3Bc;*mIzBwA+QR$cvcovZ}$vu#> zT+KDx39|)BTC%1mt$6Ck4DLGglB#QkGuK-_>|0tm%}s*dsO0<|cc~ssma(vjxYSjk zOLnpBHYpJIojznmHgW7ghHzUjt|bQH$>m@ie-(_BI1L7KE&cc*Ye~iI+j+(L_bv0% z(&>B5Idlx?KeyUvp@_C%vx|kdb~^f#Q;EKshgx=dIPf|bUM^P5{@aSHjp@A=;wATY zH`~dr9={)OozJz!suf(P_adLt zGX&H1^p7mH1(Cn>$YHIo)JHwG6)+=iFg?@$wZO{tXv`qa!*eWXy~2VE3+X$~W3l5} zu}iHyw6e2eR68q~1+x8L4YKs7QSO{&U+cod;@T!r^kNk4FBLT!CHm3l?;Bt5G(MQ` z>Uohu_&3dyFjjHyz%*(ZX>&dANKdW}P8daM}pvX%qPs`oaFn!tD$6*V~$f zHfvbR|Hhnv7TI`5FR9EO>_?^NUv28hjmS3c<-dC=k4W3?Cgy}4kr~k@`E}1Es_zE* zPLJOjiAv1>L{25o2Zj=ViiQ!R+

53LT%t#X`a*-QHQ1DQDLv28vpkyBqqzd$d{+(TyWlolWJwWz&{OiHR2 zo)+@)kLme$$p{~wpFj_CpW!?|WGk0;BmZgS`Qbi1U`iG~PbSO#j=42tx?N`|)NTK= zQ?GeXkB9Z-JWnaq^<3=Kix4L%Cya8i-a+vmlPD(o9^~F3KjT7w$j|h)qP`Nj!k3(+ z5A}N`Ht*s*H%N<4WjKe;)1mVSEmo;`j>;LacbgHDzA)?IF?%jKzqHuJyolFX2+SaZ zF@?U2&g9r*=|6EH10Tr9^m#xZ#52rT>Y-3yWi4paCWU&&4dyM;7rONk`ahFHow+4R zGO|rl`nC#AGgVmghyKamsre{XxE<~bUwR?O=1?=9q{A=How0f?@=I_oJx71E4eY_J z%Q+3q2j{VEre1q5HJjdSWEwdyEp5ZxYo4F!v+1dMo%{vsJYP35%V)7d{h+5py&{cu z5ccgJdYmLxxE`wb@rXFhG|KS#Nz%@d=Y`j6+)!VPxU9tS(Z1NZTZMYdnbp~Zy$EDw zY#nqM)Iy7xC>@^cHsL`b=h9Q`GrdheGGA&m3Cz|gNqw4+|C_p#biOg594{_J-u&hGnu$tDWk}wZBRFn3HOxJ{H0RH#ukaoFa?IG$amY> zWTe_2A&2eI?WP88=5o)`hWi6^2zDj1{y&j>lsWWcToMh(=h0Znu`%|D9#6Q=-yBG< zKbr-|?b0zz$F(?ly=PA3^4Y61dm&l#9rQpPlZWOZd6-y~i(`ZRr8)WcZSOfIlaX69 z&{q;;Jfut=JM7Wg<4c8-I6qr~aH9g1TH3+4p9bHnhCo+egTh*z$EFOxp+GX{59kX! zfEmwE*=IF{eO6nU+wc!x$GA84NymX^=~(s5f=3o<6rYFa%Je<{$Z_xq zJ#ko%ezw#{dIh(Xq)shm`!sJU#Xh=s5zWNw)_;t-9fq|dLs-!c(-#*?rylm`!nwS9 zGW)-V4?y)0dNW=Qfn$>a*vuub3=kZO+7apZjp)IP`~^T{Fm+yZ<34M+U5a20cm=6zX=B4$Afq z2KmI^uj(*K$pc35-EERnV|;+eO8mahKMOdIUG}9XEBmob9B&?I;l;Yi!3$cf^w6QW zmX7`EMhvEQYv5cuslE}R)PaxOH6Wb~+Ta%K3E-TyYj748a@~AyCpF!xtl2!_G5jW5 zd7CUX$Hn7+v5v|9ghli@e!cCWJU?raylX~jRsW#ajrT=dLlr)4^+j8b(^opG5U8Y| z?)}9$_n00lb?7;GMvL~{n5A5idCw0y9;X{o-p5F0*+4%UBNDi;IDR$@>7U4aa&BM4 zIsV>I&S7`i<3w-TEtl!%vV>kZ~(V^v2@_KW0h`+%(Ka<{v)l8VkT3^l} zBhIX5UePR$(bSgz*}4(-S#|_TgL+LaveH^&&EsIlGKf zYE--oox{XoioWQ+pWec&wfNVGo}SSW ztiS8fW0($YH=9`ZFrw)v1E!2*eJYPy{CFdx=44~_V`g$I=?7Ai>}fnb1PocoCQrG) z8#%^~3iYp63iW-?VL@Db=(;D$=f&J}k2xq(a8Ul*OFyMcM)_WiEN)vBLYH&D>q8EI zJu|WT_@Kx~hmG9Jmf-bzQALOMlXdvgo*7i$CggIj*T~<5u{-D+`ON@js0m3LW|MDY zO|}l#WGCqHv^*1^`}3H}GMk+1opsOXtI58F4o4MgP5l4zj4#X{(y2CcQbL0;uM(fr zvuOx!X2t%xb)@gtA{lqIKYCw@LguS9`ZVRDdm|^w2q=^@1^v+3NsqUNRD7RBU%#F1 zvY$R>3z%=)$CrAOhGWlcE3S8Qm3QRbIwc3<26bb@KJGExm~l@oZv?YjA~y$N%+n~G z8N@v0Usim);V2ht6-fBz0QRZqk+qf_;sR=|^_-+><$SrYy&t?kZN{Wy>^HiegOXmIneK zl8d>PhH_lXtMZ*?iN6B%3jd5J~1%eL27)mXD&DAuNrKaVicNN3cBH4DKKYBi4 zp6o^PswZ+V(~kaAM-qi zF1KLAxm-kqk~`y`$md6Y%-hRcV;wceJGmG+*+rb0Gh6d-9#4H{%~(^(gs``Nyob#E zPCq;T+_i_PY0gQ*@;c0|E@~j>9ExOMBj!_iGq0w<1qXQ^9`tdOBYlfSM?P-o1lAOI zetJ%z9=NT6R9%)Yr+P4dX8`wA*=ewUnTzPwE;5_`j0c!UJhmhI4$E7Rsm*1*u%75b z3q)5p2y<$(r#yu@%Tsd@aokycJuVQ}s37#2$NENyg*kQXL1d=U$2Eo0pFQubIp3X3 zPDO>oIat!LzC3-9FC!ZS(4!;@ky$+d4m_Xt9mQpGft*$J$B<^^<5O}wsS7Y5}g9Udsk~{Wxk@#`+(_9^dOkUqI z?@}>)S}xqCG!XyG#bO`I^UyO2KY0I?Qj%BQQBPXz%9o#a1JQ) z$m5rItPMbobowwxk%v{#2eX8e1U@Q|FE@e^{ukFd=hG09Y{l5EUh?;?Uvj8xAZC3h zcSf#x+l^d==eWq8y9JWpf?9cF@`L*=^n2uWAvYKKpipYtm?W6)o2=9@=bd}!)m5l%x3yxir?Y&Y!0ZU-Dc2~7#01uajBm-M{&AA` zEo@SfTx82@QP|_22HTt*q;z$ZRObSj#{BUkubFAYUi}K=b5MVF14%qpB&&0Rkk0Y# z^V2j;WUVIPWqsN7^^bH=1)=gXa)qbU5ZQt{a&M)i(l0etOP`WKdR#e`hGEp4eL@<@ z?#hMo?>zRW^om9d^Td0P%O#J*+`41`<+*F{{<EEg|QU1cz9B4ZwFpngmr zQbQW{kH|$I@~1)Zza^n-Ft%OiIK%b0BGL+dwuhKQcs?ulN9Day_(R@s;~Xn|+wy*+ zMsurIAaYleBc99OD<=ohX)dy6(I2_DH4r5`aV%k+K&JA(D$Voht>*K-g8XcDeOc*H zEQeW_In{*q4D#9sBXV)IR|AP@QXuO+0#J>gAJ1{`#vv=d{p~8x%N0wR3LLk8)BiM+ zymo6VUcp_0$0=~$f&LP&qtI`08oF?tjLMFa>kmDU+n7D;V!#`&Q(i8i4_zhlM4P?v zHgFM6oH0UIhy57KY*h+o?> z;pM{h#F;o5OAc|kB^=#0(l@OfdB*29ytTy3fp_$0vXPHFMZdg(%oTlU!~N#5^4A?D zZdM9s{vCOo>C{el*-$v|fDEM%WA!78z-(d+t)GdYOdG<7#L8BXI}4$g67^m;@{E&8 zE7a^Nk}2!S_hr#vvKxJlu4kea=kYa~{qpjJCw-$La4XXQ|B;!nY@|<|bDY>+^v12n zVR(Oz++|t%^i|sI9+duXCuh*sk2J@)cHqjvoG9-5{w zhq`0Dj3tlLg73d$&+MO6`oxiU+sQnqyQ94^*C8C+2a$W|KyI-&*Mhcv@|wO^dve0j zw7db!cs{?j<{D!i`!T2sWH|A*~5O|P3cVhD zW3T+R(Hm>xxaQ&cxuvEr(`g$v)91^RdA>g_VQ9CXdBi*qr{n1>7r0MC4PMl(!{KV8 zpVZ?FJUwT_xAa)~aM%lf=7nQA*N+PhWoz9=TqeKQ?UghWH#7W<-%#TuXtxOH2%Wt0lvgD*b#>;$_7uxTNV8154 zr}}5&KtJjN)#Ajvv?u3>aD>!IL>jrOp5>T%@o2wf?BRJB%3NA%^M8%bfFh826aH~> zdY3m&c498=#Y8*=wfULMN%uC$`bXpzYtt*C3;D_u8Q40I>;8HNq{MtL_{1-SUj*}@ zxo7$5&wYwtoFupY?|zQJg~s&X{6P+Jm<=Ny#!I5X19xsmU}-*c#;<0g^jsUP1u1fH$rd2X74HciO+hQ~^p!ULU(BJgMhx!UI$ zSpLI?cI1C=Z}CLMaf@)Q7wZ>W={s3yL+6|XDRa^r?iClo(2ie!P5*>k8|tuL^?fCM z8^ms!*3To2TSM_f#Q| z{DL{-W%tQ0@;Ax-UfFSOW&lp&#PYV)&e;zke$) z%<3GD_zld>;@8cIUl7XXJ6zV44@p6teuD}=cZDc(r_;m(u z@%S%{PLPymp6GKrj9yFJ!v$wx=qMY4nD=c*e((u7)`2S%vFiwP+xhv8N5{)_@~VT5 zMquX=>Tv&Npw-o4_B6&zRz2n{FVe!+n)R728TjR@PqcE&3$35Y99BUf3arM%7#BnDy|)eKuCX#`7JI|` zL?HFH0Tu3Lz_T%V;f=AP9qfhaY8_@T;dsUSJj2BCs$jotbnvD>j}|q9$diVUPvRcV z&uhOtyz0*WNan7cNQC}d1}2bO9Cd|0EHAwkxt+S&!S;uJ=eL)R3(fCtelRnw!@T*#i*^-4j-GM&Jhshl`s?&&O}b`@ z1Uarul+yn6Vhl)lNzEKHDPMF+%>_f{A8cxHnpilTI)v>(UJbB>1_=95LFU!&?l zf|U3X&y0sSITMg5<=9()teBi+g(O+kDqe1WAQ$PIDB<}=iR0&HG(9Yf>FG0Tt3e{E zKNx!_Nxyjs(&C*#s&Fi7_DG3ELwt~C$DE_dDsUI-2eGNPt{MHhYBOmX*2bPs#+YQ zM`OR%E36IDgN8kvRt3ZqI&$ECbH-`}&Px zPp;005$6n0tY9B%H6!l2u`aEmXMmdlhsZd-AN@c1UU6s1N`B>M9X8EsVv(?f&nkvCjpbm6>GaRW1* zBFTf_XYN&(44hJ&GimJfy>o0_nD0ftS>JW)|474@-eVGw3JRLV+gik6aXAB+Ww< z7(IhABD-*S@kpN~l56`=&3y$88`zaJa|* zEx}M}_^QG@#HN9$`$YqffFNvM6#~Cc%)gD~p_dLl7g-ly_JDoCJ;_rguy2^PkcMaIk93gSV`w^> zEK9@rJFG*Pm<4f*pEZE&!87_O=~+)In}?~a(G1^6-QSb?TshX#9j$n@){2{~Db;9B zjjtYk8+EL=v!=XxWiGP)m_KdHLGgO-cd6;ErVh2bBQpv&SYdOdwnd%hELnk&s?5Um zv0@AN;||rV_#8l9OPPm?_4BYWoE{er^lU0gUx#D4XyD5l2=cIdv$w=`U~gN3N>-2o zejCQ;=eoBHobDvn(H^pSwU>NaO+Tk++}AE?EXO9hNsBS=GO%17Y3JZ6Q`49k-AE+| zCc29sH9Xe`4W+o0pG;ipB4q;|#lB@jDP7Z5q$~5KqgA5)%SUpUXC10l$+s{s`8Sza zla2gkZ4*D4mBr6t&))GM>HJfaIYm;DiKC`V9>>pw-ShR-Pjs`czGo!>l816|y zxXeDxY&Ch0pM3s4@;T85G5bk_j@y`bGn1KFjYHt!&*v~X7ku%q+?E^dudx$7^jgMnBi%-dgItU zo!&2e-nRdwPDgFBEuXjV(PRu~rDNg@3$|BE$9|V|vLqH9+R0p#@HBkOXTC$a1^$Wb zBd&ZF>sMRwdO#YIhgwkQEbE0@dY_Kxvq>EzjQ^*;o5mhk))iIk-ygz^yno3N9pJMR z$!BO4Sw}u+q2z>*yd_V3j-IL)EQonc&zXF($o1%#NK7C9-kWFNLO;L_DHr7Tx z%Fv6Hb--Y1UNJja-};e@**C24+Rltdj~r6%}1 z7b{QXBJNBse2$V|9B+loKUS>YO@4STS;jrgww}!Ac>sM%no^7OBG2;aKDLuc|HILk=PB~t|V!qINOZ!>*uI8Cn8m5*QaNS&Qr>gySlfJ#_=*D(KvMZT` zeDlnqt$kB1|2mo-YTYoOu4&(XcE!KVqo_{R zl9|!I^FmIPH|}3kqLzj=zEE-^1p;dNpq1KCEtt7B^l* z;BDUsGzldi`IG)CeDzf5aNfoo>XpnWX{p7tAIzFKtA#!HI7cVa3uXj!K9}>oCCCK* zOoVMR^Pb;vEyy~Po|?)&t^qI4GNOJH1Cp*8kg~~yDU0dLScQJx+*?*KQ1{{*Z~I#M zE1oexRo;XN+ymF<*W4zu7w`+$o2`xbc+r4>^+pUEM%|(g*M`(_-aD{YMoZ3-YtAx1 z3@FR`WCY(o%3#8^czQhsWaAgtY&~{zy>>4XtEOjS&;+j8&a>ZTHS3duGg03?3!{#( z2KJVo-9|DT+*_8eNY1f6dqY|Cy)h{hi@25?=fzCf5@du9vv-#J=Ue>$rGA-+b;w3X zuK#W|&%(pS%%!fHg;q-HP8Mp5Ls*k#ZFYTf7QlMsfBU!pUQg{jWKR(1m+AD>?x7<0 zt`h$Pp0d+Jfrk%SA2HgYx~2r0^dkdC{wveKvAT$Uh*28)8-!rQFAWOTX<$!HIQl8a z!K=}Doxy&KylBi?7mbS7=>yC0t((?D-)#%}e^190e`aRV(<*3RE?O+IB8=mQ%M;G+ z@yzXnpOo-wB2y!LCHJbIIBa58W&=MdwU50183jHzvqMSh!T+r#jm*HFdpii*4lx(A z30d|)4OXuX!NJ|ZFf5HGOGxJ7F#QL|(aY(tEojIwJ$11K_D$(G$g%Hp4{~UQWGs^{ z$oNd}0**V6{5kK(z~zy~_@Nrt?@%*r9hvUa!#_lt`dgamWCKHVVO=3n8e; zdCZ=#{y(A+MUJOkbTs=T$?m_QXVYN%ZLPH+cr1JP3I@FB?b(*Oro3L`Yx5YwqH&eX&ZnvD#ksNthsjyqq&HgHF3yz;)6ru$*Of~- zPkNE(;TkR9^8@N=xTfouhX{HzUOttF4tKp}LfPgLX!eoe_gY9z_K&o;c}d5br=SGQgOp;gh z>Rq`hNnXr0N{!(OQa;KDrQLk7_`V8b(tWV&tqRj~l=z^~!ihBjpHQ+O2|AR64vABA zm@&$TWw(szIM|4}9M`_JHDY87=HAa`A3OOE1O1!aZe`)s4EncL&%)IOE;G_g~k9&C_j9}}fGElHaFW>#jGBx(N6BweF@a9QIE+jSq9zp0>F>_fK5 z2U!{&rp?o0*`NsgY@|c~$;_e*;`p1*{WZtFN#p59OE$cW&43lX=;Oq3C;J9_e9vX0 z+JkJgo==W?8vSOq3iZFs6zVQb?bIXhku%_*J0J3E8lyxzn5d;BNuS9^G0!(j=^%r2 ztww$@i&+yk6?TqQq1j&gBetgp*Fw%M-t2AUIKSyCvm!V@jHgy#>KOUTXB@{r7|4bh zF}pg)-j3u9j*|Zlqo3_fj+c(vC`aDmE%Qxpj8UlH&||C0UWIyi5`71q?bME03Uzu7 zvLH`P^1a9?R)3QmrQcS|X9lV6sX}(R3JsmfI9&3ee+siCvX(qgRaYh9S0&C(Q>b5jH)7KqdPh?CIAWmAP&*41 zdG9RX+>yLK3+^Mb5ud404_aZTzR7EKlz*Q=|HxYj3Ux#FU#!_e{?%|$@}DG0nV3T| z_2xm*y;mY#--zC@^wsR#2%6?x6EyI_p%FS^sazq)__iHlGl)A?uer?ZkYL`%`KX@tBg_n6evGm$v{mXRL zL*hpHiE2UiEi^#JuTwTqh@4;C_aC;P3Pk zzr{7~6)Ud%Wbd4g8F|;)6UTkq0rG>V^XL;fUnz>V{!)Ffj})dTuzIf@3ai;eQA&Y? zm3Al|WRt7MLU5+@0Q7he1P?N4XIh3pTP+0rr}22+(#Po(xo++q`Zv{M<9hZ8Y~p(T z6!#2yoJUWjV_!0}g11_5lXK^Q#a0B;e{kgb57@=|HJW4eH+nIua=BOC)>snG_{sd4 ze$w-YN>Vs~Mh#NH|6P$Jne6ePwgNY1(?4=MvnL8Q`0)98^Z_fDuKj?@ zR?es6eWX^3uiP)~DaTDsr1Cp&i73I|K592by%jj}LV*USi=^p!dujxBxEMy3k#p(w zLe5>uAt*a_0F>DpjCG5~NRG!j1390s?vWJkMJ1x7PdbH*2{>CJEureO>1| z=lssz3g)b7AbLCq#4$hq{93#w9hmd>(WAvKJpya!p*q0YOKr|? z{I;NoIpKftJ}=yYrL1W@J;~gTXN}Nka#ZK7$l%#5#26=~h8~iSPZGqxyh#Qn9+bE2 z)jVFpoS-B%-fwupsj(*(1$n~aN1c{WI+QKPGr8Yl>UKn+Rx@hncHo*{WI|pgGqo() z1KdaLLDp-BE-+KunzhYStexJ?K;^vl1R3W`9PDrW3w z9K9HBgq3kDp&MDtBPI-Cyjs;f3q#vxVy9Oo6r7{4mq!l%5PN~1^sT#1{mQ9!8g&@= zX2y%L#spb&I9_zI2c=7_L8j>vrBs&$8O#2}lVd8pHmgy=o3Zo2P)jdm7#8saeL1UCi$)E@gZ_OrNILWKUc1 ze%_XehhH+Gr{4bi1(|4`OHEA!<2yOV;9!MjGx^*n)Qe0Yqx-x6|Hm`>T&^XvRu{@r zC+dH3KDPch)_Rs^qhIC5@_QV0$_Dr&upRa6o}^%uQw~nfb(8hC*Ba12XMQ$p+w03@@;Hr0 zQ?dMFBuacuMW@x|Xo~8}{E5Xft`E7J?opU9ITZtHQGc+ho0Q<=>(!z^N>CJ5c231^ zSP}8gS+3v8lczoW(PDZOf@0`joS%&@b85-@)zlo|-2b~yQE2@x1t*I*v%1SgW}GRO z-Q>S+4v(fc2mOA|Sdmbm6xRfDQvT$yg2|nc>zop6#g+tj@u~SoQtxpVYDXmg2~WZD znpSM+dWAd`SOK6 zwqMHW@w_JImk-e=x~_|~^Zz4_s0a6OWEArT3;u3OZR2@r8OoY1vsXCu)8mdy8rrd5 z-RhpR47vSB&ir9c=b*=o&=hq4n2l>{XKA`GU(`xJq&<$pkM^8-F8T;fbR!x4f;tWj zeNo2{g=_6upJ%S!xVBOb*DREME0{kY<@w@CDozwwG3q`!&3Q#K|Gh8%sU3x*nPlD> z2YTLYBBhdxWED9n(?#;Cc^1Ug%E8_Nj#9(3K&)p2v132`231oLqO?L0Qb#mxi=<}T z09ZOiK@O#$j63V_DUBqT{=Xv|`r+`0D45AZm17O@J=D^&pipYB^+$&R%(<#?o{n7M zC-$vYarXYgZ1TCAqtPjW+*S=K&DQ*Z7N z@57{w6h!s3BJ4&(sY>7EzB)fRI&X$k)(C?#kSc|==41Wl{u?jTU}r7<`$6|CXYFu_f-sa469|M?nYNBX!?h~=Yjb0 zBnoR8Q|q0z!fRbaNysP?bp-V;UXfe;l7c?T*;p1|PnK*ckkee(b#gaj@(S{6&B+(1 zxXH?ktj{}9U$RFO9N(s(bVxRyY<7|y`j-vo{r0X^6#TuYqsQyxKfqZ6>3ue6nlBPs zvfgn#1)igWr|-%Fh1q-pF$j=jZQ@w8GZKQF^Z|mZUnqP;xzXFQzYfMm8$! zXe`-nsA2HQA6ptnVc+T$6lG;&_}d0D=175*t?7>j{JC2;r;`28#^5iUN%1U_s}bag zS=YAfN)L`iD~@Nl%Z719Vo3Fc!vykl6D>fw986Akl^)ZJq;>=H)J@2ZHfK$`d^VoV zca-}vHksw_kKU8GzdcOBq@UUJ_oydBHj9R3qo;KRFt)FUSSopx$Djn^+IzNmcqpZ!X7qNd-M8(yVAO z)=5^(vB{?30F<~Ih22xQ?=9eZzvv>~zl!DW=YCic!F*s|3WmJS#>cvi<=Vr1X_xDd zDcm=D=BFUDi4~PMILT?pVyXGb4-0ovdt@;AKjst9-Tuiymwe{zu!>QrhJ$jiJ8kQF5{eB9XZ}6(xAxW~x8z-?VJg|!TUy;?Q z>$fQ#KT?XR-5D?I$t4}U7LFq$47j-?9mBrZpgKsMfYM5gR#I1qyj8Du8OT3ogPkc} zI=xmRe^VIBttBt>ki6b<8;Tyq$Vl>NEvZ*nvAU6ZM(J3+g8tEE;$^5kHKBUw@O^_3 zb=){hH`>N}W4sjB=lp+a80>@TmssSB{ZQaF|kmsrqEAP6Kmuwb}HH(bc z$?NvKB+mv5$Zt|_uJCC%e2Ws`RE8YWL;B46CrITD?uf2NJ-#Ti41+S@z})C4CzTf+1K&XIK~}s8inCacj~)s zc!0F6^qao5Pab|y!lxm9ll?jWeG`ag9f_t(J0S*>(*tD(@m-B0A2EL-!6S+JGhXirH=Yd_Ex2#z}j#WV| zC-QW06**_ZvzOESF!Wnu!1`$Z+%ELneH$kiFSw&PN{iDm)P?j(=b6KXGvNvHiuYR& z`j5~1%Y?r3$dk6G|17Wb_9727<^AUCXv7#D{lr@+G@j(7l%=SzSBgHNSLpjZBNNLf z*)aA(g4A{Lz_IPr%$jb1`=xYLT16k{c?aa(d@?jU!*T100Y`bAGglNNhdx{H={Nn@ z5X!k410tGGFYg6?gm+S>^0yj22a|(i{eRpN>eDfYsZ%>%u02y?!d@-fjApN46uDh1 z*F_?~&mPOc@8S3sXheSX4D@&BnfX<${G6`h8C!>o9Sm4Eh5DYnKlh)Gl{(bZTnj=bF(ns9 zf8OTPl}Ip`XC0+b|uCXOSm870*7J67HYL{e{v8 zd}aokF~4}$B9^(RJKo!cqhBNTWhSKKZ4=H>{f?Cbylz(}P%~|x0Xve?akeej9e-}} zZ592H$n7p>|A+kD=X@J_%}fwIea4@xr#Eb4Bl@38$L?;-5$MC#b0T|SYHDI+8Zc}c z^Fh`MHP>V1!Xyd&v!S?OtQ=oSJ<8HL@*?zB2$Q|$mG1w1CrObT99mO>YIH3$&pS@y0%GEHRY3> z<|vcrZd{NuteG}BxnZy5i=E4*s56@-D}tA$e0lOS`SG3&Nh9qBr(7I(A$h~hnaOuI z$4ZGs^c1`qD@ibC*rk2UO*Oi(M{S~a)Z{8;60It@KlH$w%Ur)?94#%CXcMhO zqX{bXXs)8pA8S8@`P^e_(-Sx%XvnN8>@8aW=Bn(QuKaq z!To!|agh4LW1sAIJlepZJIlXPgkdH@+mL@GmWTyf;A`B z;=Vev*3{I9;cl#fJvYL=qv3z%Ia-X!K>4v`8EcSLXI&#Ui{63zsGrDQ@((|9i4LsI zvu>xmn~p~>(-AU^yd(d9HJBcOx3duai#4JO>^+lbJi+sbS3GO_`P6V2!P?rR4BQ`+ z!CqQAy2NB)G@l#yj+#BqGEkNMkun>&&!us0Har7&lQK~Ej*IB;ImwSNu3|0YD#KU0 zN#21blF_J<^kiT5YK&SQ{PdQ&SJcvgjNBnP8WI5rm5`S;4FzBT}5+EB?*JvrQSUk8C6Fq?>;!lGkWA+iB-#4 z7YF&Z-9;+pJIm(CB3VO^TBBQ`oS`nk@Q`BJZzz;@T?(X6WBTT#70RAlHreY{B(}K< z6k3bqpGE9NC~Y!vK%unKu^+IZP}<}cigtnm_dh6bxV$|=J}I#6G3yHS*s!G1r-J%( zBO(?5ovAS84D-%kHmN*90sXf^3Gq^(^qT_doKPfNE(IWOus=pJKPf&>K5;y2!Ulgd z=^BWLqXCHP?~nIc0VrKJ2-UUzD0?LkZ6C7Vxh?>Q9+Q8h4t~h10Muc9X!XqieNq_81qD~$A7-w6MZ~WxTdCUM9 zILo$AP3^W2dX1bUd*~aDi-XA-DyStlPmf>6qTrB8Kk2biP%*D>yOTL2^R|ktjWjew z!}CKlCasP}ZT=~`7KP)7sU6pbeB!Za+-5#r4fL+c(PL~A=6a9xIJlRyf3KN$vuE>t zD4$cCen}tc$J?Dcb6+E|ZF(y1>?8Z6BU|`4X9Vk8uwt|YONORmeFY1()>83r9ri7L zrg9dBnoA=r_{u(pIW+|r@>4NA%Ys!g7JRS3{y6(BD?U+Uj(y+{tf6=QmJLYa*&Gai^&8%Jx_GVsKVBu>X{=gYx>IlTSrJ;KN92mY?acuy5B6q2w$o_hZ zU1XsW=;aY(rS36v#mK8&PSh4Xr*{ne7E7~~kdLS32s^lWji+%8s^r|*c zd#M_k$mu!Qv4LJ;Q?2OV&x$>)DQvl5#r%8pHrPcy$FVt>$J%~l{@mn|IXK!i2cgc? zbUf=O$A`H~-c+*#&P?;^Bbz7)2zM>5yU&pG5PjMTUA<~--pLdmaX z2mA8meA^dG^l6*etuL0h3I%6j6zH(Y4(@jq@LI1xzdzJ2YLh4WM$|Q}Xp^(;xW-!2 z6NAr9=4|c+YEbpz_h!^5AK8zdp9u=sA0vZ&%_bEdDA4nu0&DqCY^egk!qnB?K z`|<3T?TNyucGTM7bL;w%0nQ`GxQrU8>@)7QM8S*eZp5!>{MDA6%5&!YW%QVMjWv_y z>_K*9Pn2tGq#I{fE9h})Ai2imC^TIfg<2`pgd~TU*ns`E{4~s8U_oXF3)1GZCee=b z&2=rvi{jk-u2lMHTJU@bXOex%D(f zaUQljHC*_5e~nJVdnMV%0T${yat(h=)jrh8KIOmAPj2bFFOsI~SIAIoKU-#f$n@tg6n}pJ+vaFV_;+)`LA($RsOnb>M4! zwBpiKYB}<~e7%{`Az-s2<^!dOq2wl^_mUgBHBb3E&YbMjvs?0`1@6hG z7tBts!L^&myc=i$|o-+kZEL1)n?SAO_7xpVtEDK#d2 zOty?Kl`^V1=YygXP0$S+E~R2pZNu4Eoh)-j87 zhCv2s4bpXQf|#cpr2O4D>CIVJyN|Jwc+4OzwkZ*7@WAnr*8l`J-Duf!`MlF1J#_QfdOCOCeG!53$ z8%hVuSuIvZ=ul&m7RL&-_^sqwbNqj2K+e3((4j{Y9qO#qqTj#aXy29dGv1t6OxNK{ zNqSm$3d7LP;b`?M9Org%Mp(yuMMux+_S8y@CjY~FPT6woJ#98(?KJ~3qsZipFyYY` z)`ggJW_eP(it{PGa;P)LTGXQ)o-G57a9U+XZ!L37o-v;C8otus|tmia~qj&XRnF!yXfdOALAScuRFV9#q z%t^=yN*ejLlmXqEQP0j(e!ni35j<->NGpLq<`NkBnS1_=BAG!x@Aa?%OjyD5 z(ruL<8R#bI2Nm{NcRG7y4rIJx%VEhIQPFAC^tSu~=&Uz2Z6L1{syZJaUb~bt5myJ?10z zPP@zWhArjR-`=vblS+!c?Qyx49hPYAF_&kU;s*BEI^8B|C414py|Jx`$-mqR0bZFN7S?|c}R)!j8B`Vdt&<_YW*GZ#IAdu@UFz!M%DwS*VAFf z3LXBQ%=gkmhxskcs58oh3*qF>gP7ZICmY8cKZN_@kwxSSoHMa~DRs9hX2S6+wQYYZ zG|&CXf>0MRX{kcfhQ6j1?Cdmn9xtEU7-bh{OskYN%f{A+1dq*9zN3ngJJd1u@kCD( z*_{KP2so@lLBqw^U7*95<2u}MqBdfV4t{&cGfrWhz`)OF9(x+Bzu9`4&|hPQ*P%?* zKc9)IE$OSepKN-Uhd39Rg+b(XG*ftudMPwLsf{?a1K$hvwr=^GrQPpDxvn-#(9r}r z{qm4FbvMi77Mv%zq(4(9%IJ2A%Klt}HGv5R2 zr#Bj~ZZeK_-7VCy+(zAE)*BMXl4D$(iK^t^UF&Dz%4D*!aSDykOogTl-_OS{3eE9X zyhdbJ4quO#O(o6JkDlqh{~VI?pUsloJW<434dFRtdXXAAFVtAaI@5jn3w=JxIM4gI zVJkPPIN->41CAEyF^k3m2D`$Jj`$J8n?-R~5?x&Wo zPYE1ZYLELp6gV4YhueevF{TppkS65Oih^Kae!uvB05)IMqdsHTl(N)aueJpT67*k>k$K5nlqmM48S-9Q^P$F zLmkO3au0m|I2suh^>93|hf=M_vwr6hxFrp?%H%3NIakO$dHlRIbmH0Dt9~wA{!kCG zUM?1X&Or|M?1lH4Q}od0a2z?iXi7&5#Bo(v%SzL}h5 zr$7vh48Yh~L0Gvt5C=8~;K4G^m37tQY(8rRS^sf_di)!zM?rZ#J@3=7`Jx4nn2&hp zTTme)4L8=NVf#tyyB9N0p3FRfI*lt2@as7_xLd!mjJf0`&7++qWt^A13Gk7?wr=7& zM}bvaI2*^>PXS8c`xXWMx?U`^_tX30Z4frFW-=r&7^%yshq#IQ`^Tx>`$~@$)0oHc zT3IWT5t*?C)%U02VAy%gJ!pYvW3r6)=h4YK4Gzg<7@u2_?wpHTNx7)KB^RH%e}cKT ztAtJRmO7_hL|Li1bZg)()+SBm6!Y5>QS|nxXpe%Yye^q`@MWL)uh2j&-WZ7E^#jp) zQ2_V&AnLjW;VEP2w@Xpz*M~KiMO$!oksc54QCDb@1(*4GP5Me*U)D;F@3J5;kF^jB zwWz1$qF-hXY{PRAW@D`)oG~NGO@82Jv_$E^XtR)4Hg1z=d9KP>;U7tf!a&l=JBC()RER?i$&kKLc6ai%3T z{QFpNHix=WmQ>uTnMR*^`f@9B(PIGpRohYX=_I*?Nx5+CmxDpnuRHqNC`%F!%EE#} zGIWPo4qT>ZnV!Ab2<|}@J@MB|6>CQ-*e)ocu1n_q0nhhk=(Tf_e4I0NeY-^9`~Wkq z4>n_KGBwM2{yw5L!}}L?S^e2poSTJ;Q|L9rbM4X3)b~Be^?yvE*}(m83}ePCa$jr6 z$+cuGtHRvKu2h0NjW$Y753@u}rT0;5v)qdz``$^7);?+s{o4~yo~TiAi5Cv!Yhk^n zMOsfSG#wTr@(*K1ypGyyW<+_KG5HU@cj9?|KSPZap7WO<$RyYBzq-P2K5=fmNfw?Q zr9L|M!{VO`&7Zdl&134s7JO7_KJQj&A~WJ-c^dUAQ_Qkw*deLqa8x|28>My)vUy`Y z(SUXP!<-ce*v96Pa}zip z=cB{%wVV%NzdLzZ1j7E+p@B~XCbgl4z+!qXonvi&JZC6&n_%c5sS0^JuVG?j)@zxTUBlQT=9xyEbb!}$7bs8K39nq+<%lbk18*>|K_F1awD z-|U5A>JokbSB05tRq(Q^@nDlDs&1xs!zbz-Pv<%4I(4BL>)&kCQOCxJ^8wWIuVKQ{ znT%Z*sE4qZ*NA70g{;57Jxfma0dp_rciQ{R+1OL>Yfxxf{j?!)5B&pq=BPMd@jtpC z|IL+6_~0xrISX9oIP1eF>6_Dzypq2ax}yyxggS$Js4F*lV-zCPspuU|cK)2J)SK}~ zqN$&lQkGsln^UNhpN;bioaK9oKQfHmS=S>xzZRz8SEU@xndB;Yh9W8G%srwTYgNt2 z@BC$jrj?U)UtA#NlBws#*Xgz}6;8jcFe_Z7J-M)rBm8hu8-?{fENFAzit(xSrP1mF zxqZP8`iv+v)U&2khcm3yMY#F(kNDK}MZ<^DSRTMREnh2VQX0yOPzCBe8HDChktjbZ z6@l60aTby5vHX$0o6_gkL|wvtsd(?hdJ`H-vkrxVdem`uBfsOHiu*muF%6~P^rK?g z^uV7z^eBwEpUU`Tg-a^^qp$yxUNr}y+UrR4DV2&bD%PFqHk1Wz^F=Y&5BWyUC$nCy znwf*9Z{4MR#vf_j$`2b?L}3PNY*RK^5&4wbyb}tg+;o3r)gl+^&beULgmnwa_vQT& zH}0wGiS*b0Mt{|v*_e^wB(=%kt*P#Z6L;yiTgrl4z4DCe%r6e>59Isk6DaS)s%zS^r!_9l*ELuiQ@m>$k2lbZN1q2hmq|4(AFh z^E%I`e|KX?**G&_)=(dF|MN)TQ3~o;rvL2KCUS!QvyEp5V2Xmejf@HHb=i1xzM*7K zA@^4}2$AHxEX%0}x-FX;YV{<&AWzODkTYf9ATOD*gZ$?EgNu`qddjn~im@h37{88{A3Ni*P|qLzbi z8pc+ouEG1pvaVmD93MwNtn<{^u0?&leO8o?Y$#i)g|X+gFX~o}g3qK>6pyyz{&)7t z$P2G}HVBDZqHy3SdC!`B|NR=vOX}+_@$p6Pa#0w^dab1%XRfz8%jGdP>B5?IdM(z1 zO%^QfPCmD%ql|Pe7N-g1DBDCMkY}^GT)zP)8i`g{D3@yZVR>)Xo)=M%a!WSW-)SOK z+WnDzXMJJ(LjQN34JM7CF5XgiIhC6)GT)E6IBUiGEXXCldEk8`iMn1Ot#YYvI3x-W zf2MFAiXJ$b^<~nge7UliuYZ%A?_ugHeq$eFj)RQ*@<;Y3`JvAw@}!-4KM!Kvwpjyd zTv#ZV$w7DQPoCF_HRkErs5Hb?VmlSef^z;yIgZpQne zDY?ZLR`h%2B*mY8%jb5!^lae%5XbuRaQbC!Z!BeA{SnEHxv6EnWzTD?o?jHkxuj&?@3ACceJ_o5f%qBkXIA6pX zzu(DJBsf@MEaf7uvkGNJM_=@`(AVCQg2lYf%^o(A@i7H5c~t-gg8X<<3Tk(xPU4Hk zlDQ&ZOyq)-L!&UIANyPHvT@*ALm646NT!hQzQSI>`1TeIcD165wT3L??{#K4bt zd!d8{UGLEUoxj)6m(&lfKrgE1QJC}(KNs?+lUp^CYajBY5%)=*54l3di#?mzw~BI- z`x$xiy^=r5&F6KPk;+*v6X<^=%(onI|?BcWPpomiuDL$S6!Df9ijVT<83F zX}3p-cL>A9U;`Zd(lKF~4VACP%I-5tG^6ir5_!XPa|V)%Y^=A%iyt|%wz1TYb2Z|` zde$Tvql3uNw6=O+a9k)>vHseu1AS-6odumSNp%IalgpD&Ni$;oxpb)NDl~POn>V@T zflFiv;>H=U?P@xE@;2t!vC_S&inX0kOy6Wc+HdkTgB6;5Q=A;#;sy)r&M$7$gHfN3 zCK{fbsQ-1Z7UTcWP+Vl4`1ob&cCEAFYX5kdQqrA1tkh?kM_t7c8F)jEX}d>^ykF>s zG7jMgwIyIjL^?|F_xkbIe)%|xdVjfLP@bZXD*2|b=Zj(E+~%EQYV2$ij)#@$ACZuO zoM;>FmZiSiL^n9L4~6w#`f*3oKO)hFF64K-cer9TA73%Rh=b2E@MI3_0rX4ltz;cu z8A`7g12(ltM`2BcX6uz0`SZgaOKWNo)X#vryVA*y+u)ZMCq4U<4zsYWw^eNmxF2U=zkQkRXqo6#>$7C-QSn!M6o*77ws$;mp| zpzw~B2V`LCW|Bh@avYb^@qVcdiJmc%Hj`deueB&S$B3v{a(2IpG2?igD5$U3VVo9@ z76a$iGq9|sLgT(XMmAMd(!W*4&VR+Tu2){CXeR6FZ^5bPVdC4&!wV3WU7gUZ-aUI`ICCyiCs2 z(GBjrK1;a1&i18eDBov?2C>qTI%rin(-lm1rJxgix?L2Sj@J{Uu&oEeABJJ|Sk5OG zb6xl;Gw{ZEsc0Si1WGkY}jxoLAp>o z?Z?0{l(|d4?6dT1_El&mP~WiTM6M&X7R!DmAep?%r_c0BpBX1@FHsM)e;B&dp+EJC zbZT=dG}Y?GN$z?jdM?-EiiX@P@52YZ$rsO|5A|0M6qv{xKB50=opf@O#n{Hrr7iV2 zE)CQor=tG12veIqnhs*;zg?av++_mjqXv-V5gA@aQE zwOG8DZ>XDM2v?z2Vi;ykrRNy$t0Vlq()oEE?#|xd{7|f4MgQ7S+@HxO zj_p9-x6|~a|0f(bzZmfM1oFtRp=n;M96sre*wbNH$Ir#qfnHzXHdHwlE7SQt+m_Ix z3Ui=alc}?2wV~#e7`ac*+Ct9ypRoo^c%1>2qYcZb+k21q!(!G0;>oeD;5uz~oO-zT z;^f&M4{V^G=FkxK)p(yIaCY&<6zVPZal^U^;i%Nf0Q0|$7d;f3_G4mX&R)U`MLo7WSzZka{ z#z}fpC0@u$Gp@}=2m(wWaQm5w0{-gl* zy1!5M+i@fLYe%<~^$%0dPD^RjY3me+PNyWWQ`iAxhrah0C(qD2rj+%&m^{AC$xff& zs#6-hsnw}xxp~RT@4ZrbE1IMXTQ;&&2iK^MWu40>pK!f$PFmMZDV@3JT!RY-<(hwj zJYX%NP2~jf$chzTY8kvfW0u5?28kuld+>`<6z2>w<`I3Ss~M#F5~J+vVvrJ!2ANql zUY3+hkl#sWxt?v7!lwoq$614bEnN4U6&O99uhqvOFZrA$WN80fjFYL%^{lh^(YWsdGvMYuR_Mq{8Sa>>tliVQFvrGbGVJ z@HusZkI;j9vI@h=zV`}d{Hjhicn)IruqyZS4_b`P zCWCmM`~5E?=G0_eL2tz0Gfc4iM2+6X^s)cjfO{?I@1!(QXP>?8Ek-!*HzIBuV+Z5h zGVZknyN&4hg={d{#oW_I>KYmGo6l*R$(ht6CZuz{zGjRVK97&R%bHg|a*geb@F^f8 z`P+zLN$ht&HsVDs6SlX{#Ev-n{%vJH=@!3UMb6O3J#uFT$~~nfBRS?Ol8IiUGBDaB z16HoP!=KYJW@b8^hGxJqkLRt&=_ngX-k#I1QeyOq4TIDJ;N2}#hS$7Hh z9_UnqLyt~mra&!6GIV#4^CQ`%XCUZ-BisvPz{2b4GXN;$)YH@Bb z(@Az!E0%{Hi{&*L#-}BV#p{#;>am>D(^D6KU-zU(fNJv}N#9;54c2n5Y^ws=1@?%n zVw3sw#pSFvbAuvz<8H_MfczC_oRpCYGORXfKFKEfQN^-(0cZQ$D)6B{b^i^;a!pq( z_vYGUtCDk46YLOJ$0m(_{t*|20{tBVP>Q);wGRQf-i|X-ul?}4RsiPtvNk-~A4BNF zFs*GM9z62H`Q7xKULHuVr9j-%2Ev^0kEw40@bHj7b&=>DZ3;lI0f9KlT8Nya*K`ek z@=u)G9PN+AFX(rXNl$7^02;7Qp{`180Xu)zhUlA7m$R?W{o&(5kEhL17*vIfVn7u7 z%!o!DbC+-Ao=N;(f=t$khA5l1?ipJgh(VXYx{Mc-ISFmq?D~+Dftn*xK zL5|AwpZ202HQQ2uu0H$2qoQ%vpI#6HqS539Yf!1tSj^lpNxcPo`S>&4_4vWsMbRhn zUbCWc^Jx@ywOBV8!#*j2rw zsc65QJ?E#XILBV^05XiPnKvC~pI#BnUOiuQn5P7g1&QDci(Tpsc9CJWZi%0ZqDO=psyh7|1R}&Fm*S3NUk|p5ND-N zwH4=Qvrco2H51nRQZAEgEXAG*bGD=ttj}wyCs#Wc8_5aO;-7E1oCzI9O{f8^4W7+` z<}GvIDArYya?p&uppon^e1B%e@AWx27iPuHpj;fB%U=E~D*|g%)3LLU?7HJ1Tka`k zYNWHgUFjl)aUPOLUDPV0=-tp*EjmvhdD~hof5m%B%OjqWq-rANH#^IP9Vp*-#mmpC3@OSU2K!1oLL+;n;H>g z?2x*KOk}7{`cu<3K1TbDgy1nuzd6vyOq-srJW-Za@Un3Lc0J&1tfL>+UZh8L$pCs0`Jst(0JNNu#5(FwkxTy3D*#o7`l0PUfBYIt zUC12HmcHUWUzN3#73}qpVZ70bzCJF<8nPty6ItQ6pcFXIrGTJ%U$X`a;=#^MX6u{DUnagw8l0<6j@-1h)1H-AlTwy%O<8wyO;T0&DxKCQ-%kGb zYo(Oc$6Y#?e7!iSZJClOz1N&i(mYH*7doq6^7sCe&b`&_Noo~XCS_#6gQPwUOtQih zD;s_qWNrvOL!Yo`)YK$ZK2wu%cZ`5%$JPHBq)8^vZyyb!Y(Ouo-DdHk&QtE1SaIGI zBdgaMU3^UPli%MxEMA(h_mU7FBWqe4 zW%lk^>Kw;OrXgO=d^5>21!r5|DzUV`n*1H-y6B}a>AjMBD|NMlRLFm$M1TYR9*k-{ zcT?dv^+F1r)CgL{=kcsKcZU)OBY7??=2>qMHMx1-a~rF|WQ`il$}lgit48=1CH)*! z*yE#yay9)eIcN2UuNggobA>1Pycg`%o#f1#LXFHH;n=7lo2b>oM%M6DpceJkYq7fv z&x0Z17+Z0K0#V*|A?*PyP*9eT1Fw0Qhji;Qhr1dk6x-6GBr@@Hw-_X;Rw zKvA**mH*4n1I*~ev)b`X^u+KnVnb#A-Jbor_C_>kKk8mbBmU)M9bOp`(#nLcM@@J& zhrR+lE7sGSs4+wKVmS4z7SN;G!ALJZYRpt&zwxC3gLp1{Rmz0%3r%oT8PW1K|NmJd zw!S0B_>|9e;T)ke`?ii5$gWE-R!s(4gPxjaGEgf%6GJ$QdX!vAd7cwZ{W39$XTVLD zGcb>AM@RPP{=P#`k+Gc5ZInSDPxkD1hEy?6owFem{rLB_DfDjO- z?imRFnhwt$8R*Hg<El;T3^!imtdDuZEcmMH_M<4AlHBW)s5ABh5l;^jJB~YK|z*fTov1vZpIK~D2 z@F29l6NGWD!FaNb`|<)ku5h1zs?($U4DRXcs7Kw)f_kIRBlR*h88=h2mTcn{dITjc z%SCbl>*D|9lBvjnY9IHbr#YxS)kmbchjd(|mJaF7r0!fFc{)!ePd)7DnOr0b=iA|k z#U8cE`rA=^%Q`&>rI!R@)rKHM_Xwh&WDr8i1fx!{9&2N%VL6bVoktmWT5Lhy2I~LS zNkgSn>g4i_b7?wRxsR!6{*BCmj-GEmxoFhp6Tb4ge7sHlrWE!IE_sM*gNsngYwnf4-`q!1%}h_?Z%nu$O)~evsa(;q*m{3&N&? zXzXrJW+qUNDE{64v>r=#MPuI&3qCSFJRF;bYmPj>F@A)R_Z%>Y*MoXifs@HJR_2)~ zD;Kj`@cleg%CO$v^5~+g%pUD3wOrfDlex_#rOJ<&Dz8iqAP?~4TA8t8lb)PzoJWKYzo{J`AjH;7kFZf`h zcD6|#zdt1Bf)C5*f#lYIsqwmsCr)~K!ZuWe^)bxPi&RKl$QeK8%SWs_>{3La-BKN# z&PSjIbIcmC^k3R&!gO*NF+z`l0VW*VmX3!nGq5@&3r!vWSGTqDvrN>O%zpVIvJP1a z&DZ5*z+w~{<#B~(iN5;wQD36}S|`%^d{<*mNzM*T=CvZ*+4Wrn&LuKN z8Ob?N+bY(=8d_5`!g*b;jHI`!qZw;hhX`Yxp_(oOYinlVd{8E4pJr`!BRv_I>n|lM zcs)d+srQgIN%A{2`FYK{tkA^#h?fn2ndK$@odaB1cj{-7Z7GRTo}bf%PF{$7L@$nV zN(`*d&+n8P=SM`KEAN?ct~$K!tiyxbI^6!EgRG^N=RIl@?=s^XuhEMl6Q;2a{W6s? zWpySJ7Spej*J;MX420ig?XnN~3-UvkV_B=eq0n#uN;9e(=h3PEHF}jS1(c*qI3jG4UWK{YC0?`)}m<(9j=k#Q8-Z( zEr$LVHyKYuOjxv%*M?l9l6B3!W7rEAnT4+N=wo_-KD2E!(PR+yDpSEvc2hB4DJ(KMbJWhd}9s&4s zG7!I?2cpb2`URg3KtJw>*Lu;XV6+~CzcOcLPW)&vHL|WnBlH$$i`>)DQcF!%p2dv~ zEJ$s~v-1be_-xBX`WnWriaFSMJQowWU#}nJErXND>6K|F8Ld3U@YYSr7b@jzZ3QA8 zaKC9oEvZHdyj`up_k{{fOb9~K(Lf}I1mj0|5bl=>LJ8(W;CrbxgnIGJF}ky#7{DAN zgp75;zZN`Wu3Y;_8g?<4p0gwkd$;mTzdV;bTP_Bl$c1`TE-IeNWxbsGf0Nv0QC3Tt zGu2zJzVnjsDQX$VTF-_mbJLBs5ZsOAimJaZV-Y=PIy2qF5d?jUwN}@AqiDvynIF{=8y>9$kNPmZCb@JdZSJ|1jTK z#<~S-4C@Y1AG&-lM%nW-x|f4~x0uK8$;I?JRs^qgm;FKX;r_yT-bf#rUFayka@?iw zYCDYGQY@=FD==xI0$U1-rP2X<5_kt9oadg2egU{$CIF3M0uVYd5NS8`_{5kR{5TpV z8RyH)(LM%Zv4qDJHqq(=4u&%u^bqg+>ZO- z=k!dtG|0kzYaX-O6AveO!CCEvnXh#i z`i=AY+yl2}>X2}renlUtiFk(f=hj2@oSO^(H%^f z$*((=COc@&MBeC3tc_s3drB4@xnGCzx(sKGXv@7hoN>!#6WKlT19P(yWmA8X+#YU{ zC$o%Fb)`|pdz)oNq!+R-t1!ET8lU!iQj(odEa!1NW?xXwHl|A9b7|yq$io^LI(fs8?u$hIrFujc~2+4pHQ;zQ3}mo4~6FH zNrh%+u|iX72JfZ+L)u>kwbj30yl|+yJCq8ZQ0i1^uSMO9*WKL}33WFJ)JyRsK;4@V z>aIxL4XF!G&boj9dFITVx6eJp(DsH9_TFDx*XLTRI6=B~(#qVnd~S;AlN}!?3+Yqc zkk{rr&&Zo7Y8V=+kC)cZb3CNnm ztfxlolZ)p%_MPXntIV3-!wmK28Mt>j9cK#Z#owB>>P8ms-*z(-k#)NbTvzX{`oB8b zfAz2*ldYw!eSx^$_QK=(q43#2AHc&|NDH%*=_`uFw8aZg&xJ6LE*UXC%!41)SR%}Y z@}1|NHJ?M+fAgOV7|#!_W0hWU)Y4E686(9r-ynYx<@Eh-(e=uHu{v!XeO8FfA_4T51!W4py7Mw z$x?6Hw63W%|B)|svb->5s0RC@sB7QI#FlF|Vt24mZjrycL=Esy3V+`pnW$5dT5g|w zdG^f{J^4B@dy^4cn2EPjnn>Tbxq>QQ7%`E0c@^s2mB}Z5agx^E3+2@_PaN1Eig(ny zC;ucbW^O2NDin%oxHmf2?$-3ejB)JG?m>UdM&!%RS;{cx ziC1IK`N7*Ev?i{sRy%W`9Ay6 z5A=5?=5(@>hqM04hBPmDM22FSn!a*gS?Dy;j9sfjkEAl*+|SA zOGHh5`1F_%JlJf+=Wkgk8`(_Gr4&jCE5OsOLQ#ode|29bzUDQN_1}u+@JI4@jmSj~ zHsYHi3stPF<;G0rBinmp(v1*w+e!|rZ#F*UHY_pX9 zJQEi1`E+|7f~@XFxOL=NuCJr4=v^pV26*Awp%7fiscLEhjG-f*F9j*{p?JX z8q-WZO)Zkx(cb8JF$7gy$TbQte&ri1j_HyyzKlw?&LMK-Z^_OHUYfn!J+h%gg=b!BI^hWVFj-&0oZhNxe z6k;t)J@dt8wFge{`uDlPyyLc6I8&#-T#YOgi}7AqoX;AXDH&fcWuo&uTiM*IM7q@X zAd4D`AwQX8bR-iuw$ziPN`+E^{+lnT=l_|)`6TlTyq{Xim8J!v?n)ohlbn}=jW}^B z3-{02$^N-TGH9|FTn2KVsWBq1SvJyEHI(RH$C4%u;wK_IZ857zObnnUKU7~ zyF*dfB^3XVjHB;4AC4nGNZ-|U6TI;H6#X1e8?j51g^x~FQmK5Aq}>~efQO-2yn^{? z@tNpa!&<&(=Zp5IC*Cy;MZZM)i44wy{%})yKe9-kTa(Y78-gKL^a1BNYqz8=S&l3e_eEEum?N|(3!@{!Mf^y3hO^rL_7I`WUx8_DJ4%)3A34d=Zfm{p4R zCF2VmM>Umyh61Tef6RugkJL#eZ_d{#Z)YpGP$1(po|w-0b542AGYzwGyEJnvFWJMT z7Ww}X>IN>1neNcQ-Bx5qrP z2WD!uzh^O{uoM0D=+D)ZK3sEM1F+j)3lq<^W1{FwNI!upsSbGQ9Do5ST2u_7w-C&D zIwnfyULcp0pvJ`{EoxJf9nSsc)VEq$PiA85mLSw1FW_97`OCg$bkW4gmn)9we>e~a z<8^pWZMQ*nGZxc}YVaRBD1HXwpzwwdq9WBa=%Vu*x0<(f%mIz2MaW z^t;rRVBY5_@w!Fcsu6Rj7n2L)UN9ru47(*!%z$&i+Gzn8Q-eBHuT=QumSAAF2=Sfj zh(?9oE(rkePM!gC^$zJBzu1>}67&8i)`}}edpOc;e@F~U2&IZiT zX>=WpV$1t&aoRIgpoZ zq=jK*8hVzYSGiZTY}YuU!cFGhOC0ixa>7%$aS|q)foFFgxgFdP&=#Lr7>*=e@svLhT&enKEFFJpbF3-!poCGg!8CF`0w zA(B7$Y%F~<;~(Q@SI!TOnGZhK9#<0l@u3zuq(}6D{ab?i2~je%jsp%}3_!Yt4$V2f zrc@?py+2aU7ujQfy#ORs)X~SIKJ$3ytlQpu?QLHO%Fyl$3IC)jc2_<2y_j!?>GCxMA zBIY|kp%36Td(;~qfG30L`ElSeHoB2lW$*s5ro6wqR-)2vEe`Za#XP>x!M3sTDV}-I z>jUvuLvB5T-W-|arhVvxx!)1jIB(3l7?1Y#*vEI%jD7p!Br?tcLmLF3lQABhAE&~q zp&9*J#>!`M%@sJl4*ZD6{o1LxTa!89wId{gHO}(k0dPGXkM&@FnKk?ElreJUnj?Om z48%6G789p)o}|y?|GzwAwGjbs3b*@)jnC#Awv1Y5c+q)|vChj7!-^vv3{?6Jwwad= z6I--2?)+S2nB-XA7_y_cL0gd5Rb9q#@%zp)#{7-JZaxca+$wh4aBRfak_V(2kB z(eNp8k=u&B0}UOY-ZY$Oa;ED!?M;I&<*&i#(W8sYcI`5ZHB>Z=I;%FiYnB^!^&VxY zwm8O6p-!%0wI)H99f*}%(e!DYrWY!aGPRdh2J}8E^C#)$^1)cS!yJjq_RJ>;N|3fA z5@g9bt<3wVlZEWj?7+U!XmXBE=%-_uA1!;X$4i$LakAs6PUgOjm90DD#mQYO8%D-S zu_f2YNWIwT;-waO=Ie{;tr`(cEiH~2)LO}9FMj7oP6)22LWiF0dGAJl9M-5W(O+~- zIr=B=Qej{cy%TOb!8<^O+e1|7yiJ8g0qiSmtwLyJB^rjPQ0JhM8LcXueyZd-Ly4tz zRk%@}ee>Ow7<@;GU$4lAuXVuj0ZKfk*UxB$5`QW<;pJCHT%;ZyTh$p8S~@eUfL@Rd zsZVWHz{d4@)*xy_Yw@*Q+!mqcUqekEZHCEdO z;o6}(hOAsxdD|jdr!v7)OS@n;m_A z0@OHFBN$H}1fg<${`oaMd46#0rD>_%QWtll=2Dh(D*H!E-{l%Sn7JVydIaa_u=yV6 zhGG18qr=NX+%I%XK)Ksw6`RsmB9k?umpV+YrRUngTG18qx}Eg6)t|NNdh|^Ft;dZ2 z_6#Ac(+r~i2G(qj^0og^x8R=YsDWOOoZ~l`bod#Yh8}OoFS57T$hxszEAoXw%!?jK z{=GJt_IUPPIMbu2AQiQ<>C4E!U+P57tPJ}Nxc9g^fc+P}(&2KB`GN=O!)QTH@l+Zn z?@Na(HNMZk=+~T|hH%bj{>RBf?oLNR$22%@Ps6@F{26D{Q2z`4d?xYl+*5q&<|1Q; zImw-Uj#59Og^cQGBYnRpW&SCZJdJ57PiCm3-i4;ps>2D;*H&geX(B6^yGVS7BN+~Rd0E+B&W75{+t$q_ z^`nCvT1>yVsm<7PWg`Q=spQ?wrgD6h1vc%c4#FB@|8dkGEG$sXKxQ$RY~n%IJZ~uQ z^C|NNjwoQ=-GUyQ7FhVYNNkv!w}o{8kNxaX^(YaS&K7{J1zzndp-;3~9x0e3#T;o{ za+0gx7D)9Z_Byh!Kh0l(o8uM8WY652?j;gGwopEVx>HWE}VVVt^I<_V1F7BokTL%Ln6o`5^eMH;xAQVBJj;*$2I#e(wXvfu5*cLLI6f zImVv!h`h@lQoRQ5_sBqv<>#)pKJ8q&(|R3eKIQ7GNEE9&oP@#2DwPGNMuk*6-a-_;Dl|Wq8iDA!k*0nhAzM%(`Gb>Af}C$I3YvUpgDx`!nCG zd^RfWqUKH==Pg;o&14WiI5I1Mf7cqbu)ALt*6hi~iqotUtY+^pb@}2j=7YV;!q5?{ z@qEfctqEE1YncuEPuW-yNp^tWHzR`ifc*TkE$hD@`&AU!^NRjR z^pJY`T!Fa`3T$yv;LG}AaqOjlV|fca8AuM88POg7G3VwKGo|fIp#$^BF1%x%jjZDX z*52-aEtJ{UO2n#F5j~2FB=V~QK3~W=9w?M+Mzcf(vR87u0y72|%e^*c*~GCq{VDSx zw(#7)!w(bZGry7Jz_^WmjN}-t5;@lT_#q{ZxmZ_Nm-_01Ij(;2x#EM4<9%_ng)dwh zaa^Q%BmJ2VZjd#&OYLzEUt@lhH>#!jpfS-;UQLd(jk7sM$FkPO8lY`;4Rv;A!@INJmpbi6j<3FbOz4@Dj4Xb3^)=z` zH4}z4rWUr4KBfHgF>=GFAJW%@ykqWn6V}F`0@&(P)Eh!e7J3j@6AjZZz-G;F*IV#v{#;F}1Ku zg4+v2NWA?08Yi6x zCCDe2M0wz%msOfrS;=$amKw3Ly&=!F&*G%lGoC3Noara4LR2jkHXLH^WMwDncS`26 zllur%K~6Z4Z%`t=q6)evDqMF~!Y^C}Tb_&4sxjMPoio(s`Mq!1FJ^9mCKH_SIN1SD z8!;m-!x2wsC~`xibnotM!s+1$ga6%1}XD~u+)wtyqgb~w%>46Z07l~@rZmUM0 zA3?A#t%mv`{rea2%so|&Yk|QS$$ekWRlar*eZLjdV5lPvWERBEjX^l_fxV2|f?>fw zn=S>QOa-!zyL1?FMEAce)Wx^ik12X&zGoeb`@nk#$sWGdWBUX4GrH^XfV^W*p5^*) zB9GW5f#ZP;<2*e!rTt%SbVdF>Fi8*3JIs`(hB4TYxg)-M3~xs!B%l2>7j!W3wTc?* z@tu3lX&u;8W5wEE1wA_W=*Uaa4{}91dag~wo!x1ubcNX!_fp~1hTdiVX-IWv4a|`_ zd-dt((KHR~zS7UTCD}xN_AO6;kABqRCZyvj_kp+g=YiMwedHQlgVRxY75iKUr{VBy zdfKc?!>$GSAI&(RoaFo-VRZ^>llh}s3NL;j|R9+WEoR!57nO(Gz!97@n7B#`IPCCVi%-b?-1-%i~;0{;VLenrK1T=NH$*9&hYIhU0(x{|Y8P&&vKt&`}s zI?17<+($BZrw)5<{{AeIo=43xYzx=iA|Jfuy0t9A2S=CCOQbQqy*v1z#7o0GkTCib zg|YWK9F@0)A<>3^PDw$RE-BdXivC}d$TnUv;oD#CfqG`66Me0cs%5h#POgy*#+VCP zP&QY|f>>J#AKX;l%;z3{p|c#=Uu34NmF&p!?54J}Q z;~tTF&e`n4A!~WZA{;Z{gyC0w7)}mg26j_=cjvJ0CDnvAb5n4%Y6@J7Q_ykqCHggS zzvsu^5YF-Oo@5!h-?D9zgYDcuZMf$s-5gcY--YLeCM{*>nD#PlxKh4}0`cR$CUMW%&5PG+F?(5p==VDy8*}f_$Ab({zVynS1bLIXAldJa8+mS&*z z37$WPr(@bnh5O}^%ta#el~dlr{pl5j`}-g4d;XLlVG5lLy-z>k`bo0vG_xdp^inCs z8Na7FVbBux&X?u-aguChP0szd$S-yZ#;w_$yZNEpz;pf$@|D%~IK_ItOREGZ4LmQe zV%En$9rj;kKk$Qe*xXJ>JDyQp9`QU%?s|0>dg&D@+|S)7XK-ENo=KiC!Gb1_e4)w@N^#NeNI)Pk^JHo@*8R6RFECtdN0fDV!g@)A3?`IzCTKgAX<09b`V! ztQ78d3i-a4lP}0oxDVXJEX<#=GOtp+TnT00z|16Ba+jXTGgatc%(XRLg?g!E{$rIW z|5b&O}>?iDD;ui5;P5?@^)@ zly^oYTNTbUR$}60zNcGUleJ15pAd|D^VHNu_}six z&prW`>3ZzGmWS9B7|`{V}|E4awHOA~!gJ_pG79J$#YEJ&F0(ZONoQ?R7-r zwv<%A9t?n zbD7`SPmRHkwYWw7q`F!MH?GwS1NHQ4*CTWquZveYwml>hl19(AxBv0~>A0;{xI3I9 z-^u%Rl8lqJo*Mrc@{A{2$dQ+=C3L@1dN40IrJ{=*>Zg>?RV^^KKRs(3F`Ks(dnQ|( zBj>{*uYAy%K7Yf%__Cfej6JepD0MUp z;CaG5P=n-T4c2#HegoI9DO<@elG$_pn1UA@O{imU;=GiDqvP3^SLG|7a4xzslRbSr zD{p+*TsAO&F4l|~8CeCB+oI1#x zSQ9FQv;T2P3aSUD;P}22%;#GF`*t=ypUFlB*9|o})YCO{(2#5X{cKdt3D`$|HqDWy?+m2|z?UQS#wO9e8XEf$u@Al|EW?<^4h+5&}B zyz#a-`zMgaXAMk%j6)QJ#E%pFD!X>IqjDuan+Ng|M>(t7=A>i|8hp% z&CV#P;tZSPO1$Gapq?Ey=Nt54UBmwNd^K8d9_kyU#sdpAI9qIcwNsp$} z*;Bq>k8S1Xr_hYvu-xxXo0J9z?pJfmrs32)j`jWIse95Fk$;{#m}}WH)+6$hWY7b> zod2Ykt_^hJK1MIQSL@~H5i)PQclK1XLQ&J^w3aDfiJMa6L11PSb-hHv^}qaDMK}{r5Ne*S=S{-`6SJ zM{!>4M<3rJ^4=#D3U~Kci86xOUy-TwD^SOa#rg#KOaJ}-tTFc9!!;saiRG3~X#bJt zw5Rm7@1e%>ne-6psK(w<&WmBxvX#NGE|q}6TrG{pp_0ujM~-n1*RdH-S=S#(zOtN!d&>(6BJ7`ArPRqddNUeA^wMTT zoXp9l-k;zEFO@U$HO^djTu`r$3xbCS;rkag5U0kc5o#!JlGVG<9*XgLyd$gEyx_b=RUw4TbEXAcYa zs;85rRdcOWs}nEt=}~>IjZUm9>t%Y0GdTsGMd{DDyNn94AC*M7ozdl#8s2<{;u(SwdZdB-waUCr7*JWJWTxvbgV{~Tg+SlzNhU~gK_i^Q-B6~1p$C=&&BE#=ebd|6%36W7jjKWZ={g&f@aL-i#4eWC1SpVEaU)P%`5jlG+R z4VP+)wj#Ne8XlNAf_&c;BeTpiac@my$sbTC*-Jd((J2&1uNv_xIunOnEk!vdR}SA| z&T=%lAy(y|xM!iJG?KgYgKO8vgE|+pgT5uhZasO)j3%=C89Amue4Q5|ykABPe9C!# zNdt*^kt?mAc;N20K}~x8C@dCH=VPRSPycYov3r>k-y{pU7VeXY0WLA0(}pSA3Xk-A(KMBZ1lTK zoV08t8C&yYGT5_ypZwz!a&4W+CziI6iTXkr?&gVU)E8SGVt(;K`dwNz5l2P7Os~b9 zo6gMV-J6WM{?ys()fZFc5*g9c3jsqk+}|@__)jJtr#6j18rrhp-`T8 z_aK)=|Il&CxIUSDZWk-DD9M+RuHG;n2}Mv|GTy~x!mfWqu~rnx)5-LyzC_=^AaarE znONm$Ew0S@U2&GV&*~7YxNJm)Qkh5|*+ed8=gN`*4{V(miu)->G~spla;lN^|6rE7 z-8|9#dFup@iUha{uL z&P@EXuP;3+;Vfi)ImCR}S+ip{KC z2|LC8nsX@1@_E}eB$GUHBgy`oFZ=G%W5bu+Ss-~>Kl=LR@_xN2k#09VaBxp3vgjQV z_LVvHVa+9^VS(hY@PJ3bE<|mhk45cl3?T2h;X<*b9cJElNeJS}jdnSdiTH3U89b*% zoU3{uO&?0n1S8t!0zouFRre;j_7(^!}nB>kRha z2WKME&`dmn@}(F3D{V745Bx}mMQQFsG8@XG^2HLN^+dK;D00YO2OZ9WYr4IxI-V=` z!#uHiJh^WVa+ejUi%ei%a~TCTPT@G^yyR9V8BLe-JU*$hI1SGuvqWAvJ_L`xFhBZ4 z7XE3P$+yP^^2M9^-8|nw#!pX^jnL(=ehh)70Y=WMjIvz7~DmP4T) z^y&>o2PgU%_F%p_`O~^S`4YIo8(*n2S!t6oE}uTCYAbmeSSX8Fv*`7S`RrSa$mH`p z?s+{)(fyN!-}!u&p&#hXWGME0!Ag3{p9wCMti|+43841y!-&edObqa{lWlwRBzpsW zZ(Yb~-b}{N1H6y@>dP;3h?~g6hE3OC0JZ?vx61r4ppJw`X^2_qs6l*3CMFm|3)kE*-nR{i^&<8OYrk-luXk&;K7Oj zY_Qa#l0z!0EH}(l;9|M`6%h#WH%8Vdu z`YMtuOy2L0aii(+q)KJp0&}A6<7Ij)`tkJ)!uk>|-px$K{4r)YHjNUWUG}(KKy5!< zi?Qv~U@Xf_ijOg}`LPqGl8gLUiTkN_WFqJn`EFpW)STb|=g~p1tE)r$B63eZ_+0&n zl7TC^udWb?!VE3S@cuqIT!J1KBjxTh2ka}MALVd*QTabcIRAYMpNA|D2i$rbh)7!< z&Ke)1RSkNrCr62nyvyb2K>Qq}#gEy%UwZmT?ur%rN%V6J2*iOR9sH`$H{b*_PgX}u z*G`V`?a98V8(MVxLl3Gi#mG8HUTn4sZM*|aql;BZrtfF9v1)zk>rP_wa5g^3!>h>Owk`?>@2pRdFfe;qVC=$$a!jH2>!QYFy=7JUEtb+mZH zdEkl*`M8k7Vi#)JH>!{2u+^Rkm1pzFL6dpJK7zb1dj zUZ&7Su@X_ykzP#xs1mBhyc%ir<|{!A$DK`m2V7MJB4kTEbEF@`VF35%^`j+h1G!f| z52d#-U+dpvga**>uTzwiucgGM#Q`vr1zNTu74P&VaC{XbQ${KO$7P!u@V@isMn5P) zogL8o-_Cu?RI zhsgaMO+`{Ka(v6_2fES$Hx7^+C4c>VdMd7R{&~Q8?;<(hDdz$Z#P{>mgY!=p&Y$t| zGN!Zx5~$mLir_pf zBar)S+x&i}*A7;-;G&a`vDLe~8{alCAP`54WroAGmLgezw)tqVeRDfyTNGER6>(?A)+) zzH#BpOoP?>{e~y+UKv_#3pdQ@P~CX?RiR=0y_s%%FPt^3?z7v_u=ILElrq(@P+8YF z?ZQh#$4(F3%4!E0X1||kaCukXP+`8mnQY zv429{e?g-Bnwmi7F<#!LM9b);SSccZx@1v;G;fk1DZjNMvtlG=Mx0z$#7a`*M0rCl zIVgwU&ph~=PKi>jX@b16O%U~)7%6zhKGT%{(qnp_4zsJU*RwKvb=iO6 z(~G&)S~87%{hf=c`(M|iALnZ;TlTBY)-&&oo;>^+n_qH`c&o$pEqV;N&Uv*v{T33q z2JfW?|D8TKJ((+?%g@{=gvX`9ZE_k~PG>D+Ed3KVrD0KddN59=H$x_QMru~0BIu1U zJPmKigNMwZSL1SKdf3y$$A*2LbE)TVN=MzCH0DM9U%#h)Rr)mArsE%9|4K16LH_$6 zMLG_TCP%rEYi33Z=~B~48t%50$e&8-v)Wz;oN$maOPk2Ee$>|=+RMDx?D^8#O2S%8 z@xIzfuI+6uWo;cr$IR)juC~(6h2HB`o#fs@N4Zq2lBoU;GJ0q;i96F&A`dtV@>@$8 z>eG8WIg2lO$dPVNvgehvj7d<5-pW=At~Qgtds~p(c9e}gGcI1nyq;kS3<)wz9o81t z@_fIoQGqmBqQJKS3hbaq-11!|5uiMB*`jyDIOtX}pW0s&23vyD-!e#Ar<2>rUBQ4O7{c&ZU7RdP*W|mX7s?W4aHlH?v+#pB}|u)=m2Q!CcV? z2U#mr<$%LGp zCe(~FVb_Kf+*nFJt2S%o7pb3rW;e?RX70A3S3o8DC@eAIc@}%y_R$yePBPk`Nyfxg zWFWvy>r%;3dt{^Wa@K3C$r(0d?WO@4#Ch3xUybZyy=)A9nF*gYS@_0U@}Nfah)d4G zQtK?NTa%4jN2tS*2bhw^oRf<@+r?$U!bDHGB6>TnV>Uw!`yZcVBj;2$PTbAHwSTNL z3}@|y`bb?zY9z18QLZFkFpK@A#%zQcvv6s#i`dt1Ek*2WY&P6l23fm`S0872vByRt z;3Vb#Im)AZ&eH9wjcCpG66bC$x9hX#?X{hBo~DwFL@Q~$(?PC(v69h~9OUqUrji%S z9$|jI;AJCKzS@d&I|m7@$Sn8)PU7cjBQsY!%CZb+nYpWlOcq;dJJ6BY@2zFzNC!zx zRv@_#^Eemqxvy%LGh`X&tT&7E3>oh ziFCSemZFO6>n=m@5VFIjv+Uiar(=ZxdYm>e%c{c)xb?O`Qd^E)`kz+p%*=`udOL2j zK-i9A2~m`YKiT5QJ4LeM6mzVt=nHkq8^f%8Fw4~!`#zErZsdn3GQAZez1W{k7V#&2 zO8+sp!=D)uXS{G_o;RX4F*7vQ8+qk@v6k5&J2`Iht-N3{+!w~TJ}7uke~j;Bj|ckx zFIRK}d5A~Z^g8Y3iytR^(6WXvChCUavz9;Wi#Mv!AM3#sdPG|D`S)htM}7z@kX0BO zsv*;_LA%l#to}`J#qF&5Xqa0vUxQk#A!c(-)h2V2u#sB9P3A2WG0)v93@QA(iFzK~ z`SkMKxd{h8 zA!Dx7*RcsXWpc~CZZrS=F?~rFFmrkfGlkO0BfjNxzbFf;<5}=nn?)}I=CzTrS-}4{ z!7m%n&Ez+xQ5Pk*v7>1=mUST8vN01a$}y8=5c@T^F+@?hX0?hJ+xvrW=S>z9I_EzgMF_NdoH>KKQQEazPh;b*J!u&2a62- z@~65P!@Ugk^)Cz+R{Xq})ndLOD(8#A9R9)3;$X3%chx0^)qYit+dZlqFYk0PJgeBi z*x^APV~ti#jJk504Rt?FbF01bm7(*QRfecKC)`dQdvh`WO9f-VHEq|pj8|P;u9q@y zG$tBeUYvDdfw!O0GcVg<@Y8ka+1Ak*zbIZ>M$@ZgrCzk^IJxstCl~W{(zhg5u6~FY zTeo=md_Pf2*P>oBE?SdK`VkbP}>Q zUd*nsGWBqRe2&zK<*zsisH~OgmU@oO1gXHE`Q~YytS^-)EvD-v%!e$>GQCv0?S!&% zDzvZfgcUB_1Flj+^TP@AdpKeLK%Vn!IHS`p_AUKX!Pngp)BZSO;ZG+Vw@~6f`(k#R z=&N{?eS_p1Z8qOB`kI;p*X3+9R)qR+9;Xp&J4*9N^GSMN>6ex zA!H#RQeWD(hCNW%RG7?ur%m?*fU)dJc^Zh#P1X3jMvWiq$R9?NXB-s>yW}90@Lb<` zK@fKP1mPijrvm7wcz=HoPB#z6kQIRl@K)ocAA4l|>E*beIn!xsEPTQ}AZtl}w}arl zf&0)(^nsi}-$w2OYw`P=omQi9I{$ot*#u6(%*j@x?jL3XG}ggap~Jw%%uKth!=GJx zROzULu{1ptgV?Wfn_gaddYt6GuM+ohvE>rrKatr9(-Uy=IXzppvECX=*3n)Ei>f-r zvj+P651E|>^t$rau~$})rmKlSzEcz7^^chMC;+@q8Iv#2(OI-0Sgc{zTE&`yTsV0@D$5mA%eY z((!F~8Wf|_@nb?dOh1{!>7R!7Bj|&sWR_~Jboz#+;Ylm9D4}V%>(30@dg=5EOvi({ zjh6&AA}fu@N1|KcH9YrihB}W%`oW3YH%j>zpP;TYiuR2 zN6p;*LJFe(k^O2!|D;Rg4ZO0ELjEIjRSwRK%ptRujls^$yWi>{C!?L^`JDE$RI3u# zAUo;W(LpL*x4@KO3v`##_;K1S^~lGa%~D{%K5smpGz`TNzKD1^98vxJ;Jt4c0=I`D zU|<-ImJ7$`N?};ga5vuf48yuMmr#xK;;&}RS=^a|XJ!*FOiRHiYWMqv9!{Lc>N)4& z=BjKIS~3fg-pb)FEu>jRl{9x&iR`nHJZn3#9;d)zUklEq7WgvO0^b%{;PoyA#!vHu ze+@rm@)}*A;0yH_W_J4d!l_g^a{n@KnrlTG*ADL*^!Du)hO_hN`=w36&}SwL;oSZC zp9%Zla&N`?HIY8l)i@{5xX4^(UYk_1Gp&y(#X`kwaA_rF|F)4gpY3JvB<{nPmcqUz z7U)M`soL8V2s>U1o1_#ra4o#&<%eUVe9_0&7c06C$Ekv0=w}^<6I|=AZwW<%8Qc$k z=YF$WINoeZW-lvw!7I$`Oy-)B$^D)?*O(F67!kug()VnPw_r{tuh0A+S-9QPNpM*u z?t|OQ+}`bE-evluopzA3mAO|>D}|4z6*zi}jEcVn+P5f$JA?hOq^B>+9`wUqCm)RE z^(vlCzevk4m@kFFMXkZ#KI{WHz~`x37GD21*d`$Jxz@%U3uQkC3|5RjGljk@TzM9WT+l_ zdlInHI{|Sv^loaYNA(&R2pW@)vpfryzMX+%7XT zd9d%zD;6HKG$R)E62)m~mJdKLuERJhL^qLm?fogA#4 zBr|Iz%Fs4?>Cr7o%QtD` z_0NIVMY%VKp55d=gM)FmZ!mol^tdr50hxDnSf8Xv3kP~MX7l}Vy|K&XeM(BlhkhB@ zc_$tE3uzd!i5^nyGk;pm!abfG$TlZ>OZhQxb$Ohuphxu8GDifhnfKbCxg|a5dGXc} zvCd>+-BqZ>eZ-<5B?jg(+k-q)qvd3qCQ%cbNrvYdwVnVqnm*R!3ZI_?)M7sEO<=vB zpUWqp_v3Vwznz9hYtk`@Y)abT40=^iQ(2*KFVj)sZoaB;k6o{D|FlivK6{wL{p(#j zxsujZ-u8DEOO;C2am=@#Ku@c-oNv07!lii%IEAx^vYP_GI0rT1oU?4PFRX8KPFDF~ zZ?P{tcs|&9m2(X_v}2KB*q+S(qzv-!l{oe}7lv=(xpjOB{@qN$LhixWk!{?Nor4bj za}de7aLI%m?CQnL`}Oo^yxU4NQEkL}gi1DDXeDib*hq`|c2eyIdoP)z>`Xo4)Xx$b zQjgwxBP>vZeu%B#`yr6$o9NA)dmd0ELJjf3x7Y$=35YIlV zG(N!`V=^+*=yC;gc-i&J{&tPxB zK=v^`au$F8mQvg|g;9q6g+7=})3sg3+#X5SMHX3f;##9s}yM(PhuE}_M*WcKdx++#=1 zvY6gw`Rv28&!+ziy>mO{U{P@vy3C~K@kRdZmP#3yZ6l2zI!f^`2YHlaBj(lY>C3TT zCb$CmwTnc(nEt*s6gcbVgHWRrWf>uFg)(AL6V-?*OS8V zaUOdXmR>^7N7ON{reFcjT#4QId2I?>x@O}5ed(+4I?bHI_mz>2{*h$iM>|Qx!dCKR zZd*zF=pw%~%yDhhMn2Uf`!HSs*TWXbyjdu2nqrxnTP)2EdLtmt8;g(m;C*XfBsBlRsLQp;7Tk+_gr?J6~DgwyYDwI2K0(O)k*fi)%eopVpVs~`b64jJsBNQdRn z4Cv}`FWWF3b-0ENrib0!LS{M}6z*L%D%_P_I9F%TUvG7ySY1z&{A-Ca*)u`X$0SPH z?gVMp*cma0S|IWwna1kQm`4`=`zU7|ObtdZd+5D}uwTAYFb?L>cZO@)+DFXpxv9s5 zBg`!JOu$o(4lO+rQ12Q2b9d3xwSCY_6kva@1zdg|k^3e?;E9 z4zJCN6-i>Tk7v0KiPG;;yiA_27njE>tW>u^`*!rLOyhcSPzB32&bW7ny#ZaxQ(h)B zIGgjdhG(2n!T2{n0VmY-tIXG<^;`OX>|>2^a00Y9GvMh*u5ubVJu9wZTj|5TJRSQ> zS-78>q;S7S*7Kr~^P!8v{U&<_-X7x`Iv_!2oJo|o)sM>7)=6@uRFdr0w7^jAH`=ie zt$R&pOg`<5X;YnX!G?@^C_V9~1Y!L2Ahi3c#?IcWaQQp6@Qw5X`9zI;z8?P`>dom?^;cl^xd5H98JjA`n{4ommRo2X#c4c4R-=h-D zT8M^BV`Q%+DGJd_k9lNYuQ;QLyEERg#&FlN1zZ<6qr#tHRH>lGi=}F$R$PV8Jo~8^ zsgdWZ$C_N8t?KEK@k57f7d^^dps$CLEG7Mp!wu=k_?U{e)Ydb$^Xx=+FoxH|F_r8= zw8H&5uTf+adlx#=S1C^`%O)ps-x??919bAxK`#-%oZvfLg+{HE%!i~mbX6t1YCGcj z3HD8_{XeEreMgP4$9R@aq7QR4+0M`OE%8af%&$5OAD4hrWKmOZvVPc(e$YIRb-tDc zk80`kGRQ!bkiqA=KA(FHyRE!m?By8E=lZ`|*nb~ZeJrI~26><7-nd{Ff+_3+3v8c> z=}jzUO!Yz;7~z3z74@p>Hs*Ad9w4%EE-|jm7;o{mZPqFnn7G*+k|M7iYrbc~dDfDvv#veQP2NzmEE#zgndn%9+?+?gwA(Zk-5o>m^OX?|YGz@1t0uDC?w_RV zJyGgW2nO8?D)!LND3&htSUBj)_em{&OaXb-v5h6QMxiug-t?Ctp;*PU__JG? z`2CxCvSa^9nf0FNbutv{b4Ik{>tq`(<#6`@L)uyYMU{tdf52Wl0L37b2C)wV^WSEZxC!&XA?6pPCsa#h9%bmejD*)b?Y zmGfB4-EL?jy~tx0lYbl^z-L>p|K+xQ$?@}?`HxD1enoE~@MdJL>8-vOtaJCkm z-RAV@Ju{P}Li+5;b>1PDTH?ffbCW#SG`5gnb%m@O;fqeTkvQOzifugaR=nQBc9zR( ze$FRci@~5j>a;D_Ws|ZZt=W0;(YMd(Lj$TAGTK zk$IeZ<8`#AMC!NohN20*t0!2?-AF!^xyCE67l~;dZ=B%qpZ#2q^DB7XueB06S1h;O zeDIHD1a=hYQC6EC$!E>PwN|kh{_@7BIgv=|!TyXB`yFkY${Ky4n0*|9O!AC_caUR^ zVz$*AE2;cY$UTz}verbxlN@eoQZCNFZ!Vn!nLoaQIq4h8L6e(KBd44iZYM<-d4Avc z;7J>vmqI-nT+c(}pcYbiw@6(69)b2FcwH}GoqJaqo>&`8%@qSCkGc_ILnqIqf~m1 zz~e^|aI++rx*!)XXW2-8e5tfg^+nAc5ilqBU7+H5zu#Pj4JnnYj_gs;dmEdrN7ORr zYj<&!4UVPqrjs9P42gglKhKww^HBR{3+YIHS=rqew%m`-8kmZjW}N$P$a39`MqOIudl*(0>${VjJMuhXyW+de1}r)YXe^Z5SHrK0a5e*IxfF+W{M)|9=? zsq}9)O@)fTZ{y`w@*<>A0>As>6VFSFEczl(=c4#@3u!Z;SZca4PwQqR0(|v&T$#%( zf)-?ROJyB7_sPp6u_9NG^e0QtE8IIKbRow+(=_n0uuxu?Q_8yRS|tP)>tACsRQ9Pv*lC4%a3uc2Yi?-lyI z=F<~rN-yE}5JaCO2ULarwZqI6J(MUn%Iu(66M_qaROqycxycokQ2EnGO|DQ@grX0* zr{1H|$x<3IJt$F%=ueE@77XKa@=CQcFk_q%u7Ss7<7r1sn;nb=?BV-Za$fFLC1*U2 zai+l@ny;bg#M$KT!m9w!S=*yEiK`Ox=C|C80&eiglhOJl@muRSyD$Vp97<4XNZM0cc@ZD+jP z{KElf-h|K-slpiYM~**?81ng;RM|p)?Rp4vy_2wF0{2rkWSb7zI%*?SebhG)RDGmk^N1X0t=8Ff7r&wW+& z#xvJ@hY^?dF^~JcJyOqwz;!7508i85TS;GJK#Z)+vZwzi4A$fvt=DFtdqE|}9pmS! zwF4}xv-h!Ag@h@Y*m0r~Pv$2`8FRYbSBGNV8x<@|>IOQZj;4zHu4qrn(^R)zMB zS;HGap0P)qTzKV(r1A8nJ|QnQAph@Q2|IfVO8uSU)ij`Mx zPB>p94FB9vXwZ?8vjjaF(ffFh95CLuWrB4{OI~y;bp&+m`;p2mJihRbh7x_HFta(eQelyn5n* z`wf_99gu{un9$d-P0YuKKx9 zY&B6KQOmse6rRVTcv;KqD5rA>^4yt=^N80)ZzGP^j+Zv;c;841Mb)m%gXxfo@82si zm7HvgP03% zOOBGSzrp*!$T4x!q`m`|MTB8%eSS_>&>KfSbPb&^KRP&}l>GP}UUyr!Wgs)qh}dUb zkFGgjB;BNm z%P%i_v%z!I?vJ`>W~Ta?lmFDG{Ozf0y8o%JaakR`*I$3@77cOGcRL%S8$a=E&lz7$ z^p8z0>7FhcsXuIALuc4M-g9XCs+Svf+n_tUYNKb9^Hw@z$1r_O(~h1dmpgfsulrL! zc6?*qf!qJ;F4qXZw6oLs%NOX)Ng>aedrT!Q7bS`LnB$UjH&M=9P>Cn`#-|$+<=jGz z^#4Lnsds`5nVuvIKXcZwaguDEA1^yEBuT8FS~g5%zncAmPl`mT@;83X(MmJ*3Wgc^!>|D_xk`BlkuK4xX2{s8%XwZb26wxkt z|J)f(In#ONRw#5)p;+3Dvy!Y&`)p;sYHKKJ^I6}9vk~Wik#}W(dd5U0x}0I%dVd&x zc#^q($+~(iGP_rlu=~gyB-TxC_f+CavoPdU56Ag6^!3c;-#M$qJ!d6$&*63cXE^h0 z!%*SQ&+ayQcnqwOC9x*X+SG1aCGtF#SjWB5yV@GG`=Eg(dnvVT=&s0MFWQRUoG0Y( zn`p3{z2@aV$s7-7_R}>D8n6a&H%N+$F*HeyPu1w-xvR!e{+)@Z==7PX z#{2eGF`96nn)EE*3+P(fcK2^YW#VEnSNvyhq4yd zK81PEoYyFt%X-G)EL`8mJ=xG~__fbOI&1Vhsxc#jeP^>Tnds1sb)hGjSjw7E%y>F? zqOxFb#x;ZWtK(joSkQy>x&O^BD>Lz%b(;G}nGLm{f4@8X)04<>U&zF8YwmTdvM}Lg z79Nbu1UhCizs+8(`?r+@ahBL{H<@kYCVQ$nN$+NMGP8=al$zPd1kODEeZgKnY-lCj zXWB_M9~W^Cw33^@?8JV!gPgnNESriPl)^hT!y}W+h zMgr-q@n&t>pR?_+EZJ-IvynBm-NfCtwQPLMezduR*mSIv+EdEJzqe5itmm9!8+sK} zDp>oklp|M+@<)H8Onaq3@C>8$t5Yt=nk%3@Mo<69GFjNUTt2K)V12hTnK-smt~r~a zPhE0X4(yXosg$oV%)`A_A^yKB<&Vt@9R5aMjyHXEEltR?Gpl-jr9^kDklqoMa^;Z% zveE?ct9wnVo<`j*JR&+12 z$Lr7f(U7rG_{LiG@HNc1UBo(86#a59BVn~M8q==RyV#kIxj<%5vlr4bggxr_l;&XF&w^^WT^8Ym3%LqtW1K)EYp~KnDY&M;UNql>tij zlxuAjmT!8riYW@+%FiJPc_1*?^>Z23Q&la34p% zPAOT)v{YmsGoafKIssx+(fvE?9_gu=-H*@BW@)%PleyDB^%y~}OXru0kF4iu>!hLJ zUjy!%{?}LMGvZz{h#}+*?Ab4F#Qw+@G6=VriNL!1fVK1+^vuWR^LfZC&d0tf1-Q$) z)4J~Y@Z@Wsr7=7A95bFe<-u!k9_CsXVAYF!W}4-pK$!>YbM(r^=Am5^_N4dZNX0B_rGvD1MqgtIT}aHJ+^-|s z!8%=mC9j*}3b{XxdG0&PW!7Z{{VPU!Raq{3(-rU`2Rwdqh0KkslwBW`MsFz$eVIWy~>^!b2Xc>-{hNJDSh8pNZUmU zY>72Wyd&MK%$s)2QQ%2u_7L~_BJ!gjEK->fwurgy2LjN`o}YVizjetOzVP;k(aayk zCH|=M!51s`^Sau@8sJNRbgCM_enbEokvYEgmp?A{VK#hi=CZw`i;MMvBW3=q53sM4 zO!sMje|+UL`svH`VD0zEb9ZKd75d`PUqJ{<wPPjo7 zdW_*U$$nApE4sgU-94#FXX>OVWb(C-0-~^z|KIXm6e6y2W;~Jp(@o@#hesnq8I7I% zJIiX)?{tIL*hkKnvbNSL+kmr5vcJyE_~iApwiB6+5xjOP=w2B^H`Q5wt(O7cs;A-X z83W2E8-THCm_Cy}l-107<8`JV!fUk=ugz2B78|D`_*p6@pG<` zk*fh-ymng@@%67$(QCAUGYssh{m4h%SNV7_K94Lj{UsmxxhInty_P;xW};b>&zRSo znP_eDq4~@l>YJ<|Ud=-lUW57vtflk+nN8&EI{!{A@;P_PY_}ltLB0hT8kC2P3-YjP zTRxgrqsQ?}9$t^+b#ycz)_Q&|f!E+Z{=9$qx~t5cc3-SxJc<7Lwk*#%+iPF8od3c@ zce=LjVZ=S1`?_%b%IZ2@%iT8mULN&58(iwCAJF`&?$E3+x>kOhbTw6tJ%)c;r}J=` z?%|WYMVJ3-y@&U}Q@Vf+or%Gm*sl=zNTFgdsrm(6;wsL=1 zSeHKT?P|^tsn~Cemn+U1u_#cBJ?jtqdyq#os^oXJO2*w#$s%wzW_q&h&EnrrPLgcX zBq`s-IZbt%jN|vUaz(qw&RG4>1u@(QHmO5r1=$IZcZqxF zjDxpb5WziSQ13A8cUPiLeeUzDnJYPo`?tDbuwY-)ezX$N+_x?76ppNY;bd{>C26L_ zm~r%4^-yB*3py4jDly1`E{>*3)E*Ry7sA<>+05o(eW1sm{643YSoWt9uGwLTJ;HqI zc62pb)5GW(0$(-vl?}t;)HNKRxyL-di_e66)wq+O#)NRrp^)8}^o@**AH65nG}ymc zO-C&KFzk)l|59VmKn?Qz>Cv*_Ow0fc6!q!t{+BbZ%jxarY@^3vdb)j?ZPr;0ud`}Y zyQ#+MwQ4kZ&Hn5;HS71x(L2l8nNU7wr7_$34(llFw^hmEeA!ZF4Ll`3xtzImAhCHcwekb0?dq&%*auX3Lq;#p03$PwwL;Mlh$9Tw`n;=Tx{qywNZl zPf{{a@R~D{37K%__f)gj>Qj^19Mzdy(3ZXw`z$Q+qTgz7CN5v+JdBR}OFOzDyU_pW zPcE`L_mk8AAJ5o+qrIe`bd>qmT&4YUH+j*qv&{WsD?XtLZ2VOwBk5%zFW7+h zvyp?-&>_lzSn_DAcJbOT&cm+^GS3xcpXp5Uos|#gGAH)Mm@#ecDE^z;OK+o{EcoCi zH_n-08Xa4+>d?7eZUV(}u0>=+{)rC2mvleoBKTnf_gD35=362D7s5>FQH+I|I+o0;OoBf7vQn6M5;hGs(mu3HCU$}M`X zS_NX*s6b439Ec&V(O7wlp1-NlSkRq(%7bY9nol2?!hp*8Y52U>z~_!M#H_f&%ohVD zk^^6y!h3I4KCX}pDR!rWT0`bw5FLn<++{{}XNllmd(=-CX?vZl$}Cefse$?2hky-_s1`9W_L~s!s!ixaOoJ0rQ^xV*wPsZI;F^;wy4ehpD&ry zyQ%ow$o<|s0|M5j0i|T%6Z0@?Q2}~~=VKy|OX+jYe9S4p$K9^d+p)8l)b1kJZRub;@@QfBqGEiwoETJYayPAM>v(^YL$Ot~sp=;IN3F8}9L{ z#TKBSlcU@yv6r=KcX6uWC@YxV`S5dVxmvYC?#?j5ja~}eBX`;$M!|kBIi5#>_~T9> z_xyo4d(|Jq?*&5DIRMTEI-89=R~mkvdG0K@ANZLPg(&h(>p34V>Jn#sxPGQd8oX+y zA!!$ToCi5qqsm8ouL9QF=^P%Gk2$^?*)=UuwiapRSB+%m25P1EC$)_F(+L)3yhpEf zhQnTGT%PI%Gh1i;T*`dl6U>~BQKH7PaGbFT$3ay%Iw$iPGlp|>e`>KImu%W&Ey9yE zaHbDvAMXnX)Y<5MGYb=W?RPm%PtjcZnp!hggu`8{3ghfD-HdIN5RcV(HYOY& zj+4)8#reQlTKW+=4|tFF$ZRr&ZhXEymdW`Kx@ccyqV!27T*!pnT+3PejpXylUu+nu z@Y-5TXAT=6BC zp1*}kbi1L%0@e#k28HALrZD_GMFym;77e4-7(GqP=W{JO{$!mylsS~E=x;hfSENlg zG6wT`+%p^7SqrP0tngBhPg&lV$Evo8S7Z9EUYn)JqRU#j@1>Q9M_LK{%J+6%E9$YX zTx00ZoX2yO#dYx}^Dw5l;8Z>G^UvrYd(D0U*Qkqt+U%57pxGGYuw~ zk!k0e;Lr2ZfK27EZCQBOp6uz$EEH~JF6C&2S4u4tuVcf>snF3__dlMeMB$Z7o=ACI zExjI`kP)vrXM0s8ZpmuSCOX5*%mr0LoR~f5g4-uuF=>k%o|uK>;{0$-a%4v4StaKd z!qJWAFl{dVW2|FL)M;_^Bx@$y=`NV9LFomqA4ADA4#~pprCFG_m34=!L#J@WriH_cOwpH5O8hZOgCnfl{G9Y(rUqH3Dq2KZYjKM2r5}I( zU_&O-xVAYqc!F`CnMc7|@aTQ?DYRF3WxS^2ig~Nw$>+wowUsKToMm@ECrOER7d83D zj>FvKBA@$jIV$jJt0@w*6j0_@h@RKG>1n({ z$N1mQQdr?ATO!+teP(+(_sUJGF1M4BT0Uo;Rv^Q)QqoTu#ksZ#-bV6%nB<2xy8{r| zkB)k-9ecBaSl=Swt%!#Ckv-UG8-+a|qmbhqjRM}IOAe$lyUc*)T(@R(O%1_C)$)kOh5+u~B@^V21MYX!u!1BaH8- zpPtX?e2#Hgn1-lzY4B;3hQoYr*SF%@If`pKp9um67I4m($EbDz+PJvM!L=Qv@x(6j zkTs=wTiZ$1;7(%Nw+aUH-YioT=roe7-t9_e1~7+%nb#wF_`~UtKSurZhxP~ExdG(y z1EcXt$iLr-Mzohz{p(pYh zpUoC?jla(|>=jwl+xeIrLJwkcJ}&aSSs&paIz0!a+R4J!t}-{*S$49{uwh7BF>g~T zZf_MBzok;@%~hanCEZ%q3K(Vv;kkI9X2|(k9-oYL{%FAC^Ym3TT6Notb9z40 z^4WA=y*(Jo&&~)xuBEnDkij)x_VK-4=5cz@{E9H{fqHXRVJhn*;8xpqAc$LSMF z94%4eyC0n^$?gMZC$xw*_1$jwrk$ zPIKM3tnf-F2S0-SQ;T<6*+CD0C7l9ScN~{hj%qo^bv4k9{9?KjI((#KzJ)WA;D%*^ zbka9gqTx68vb1#gb_iz(57>(v zQr#8Oo37eMZU}wpg316_ES~Lxk#0&<`Kg4C4E#$`;sBp#>J1_PIaq@c^|i1ati>fq zEo|m%aMel+`@&2ljLJg)nVesD&c>BFS?D;2nTllJ`*2;K#`|&!|8)DQ@cI%(ZtwL8 z88lxbSLP?l!G0R)`-|-0g5y%-kqb`tbisri$1xTkap`{yan}=gsZRR6gq6cV{ z5?x;^(JV;G+$Sy6ff_Wur^WOY^j2nQn6<3IR5GW3&d)}cR~E8(zOn~rY+nyDUt+F0E2{b>OkF-@*4qmvGLWWXZjfB8AOVVo_Tyo4%=KHu=gc>@`>paK?<| z>|+GD;7ngS8<&M+*bF85MJnMvMhVkGo-58#jOR0y=`uc-jpt{kj~0_ZY7n$TgD-tJ z+x3a_8)LKJ-ktMax3iF=eCCXvuPe5$b7j4WtSEfrqg zWIszL{6C&Cu9~@AaxY{ytv8O5qtQArM|esOes*XfHe1W3)oF5n(Gh6-UXPtS^YFN= znOwV7CTD+>6SRrIvxcnWtjWc<6;0$*onMknkKyTo5ePhHfUPkHCDG00!8-cptbDNd z-$?8lPkyj%F1}Z@kOpSuQue?bQ@%#RxK58y`#g-TXek?qmoPKN2PNdQ-rA;O$E95S z`r1U6{VbGyEq(D%Xe2s%vsSw!2c31zWM+1uG-~6G{X-*hmmE_@MlO~)Tg!S4IkK1$ zI7=RC#Y8<+fw`D`wUyKvQ!bB|(BG#cxAl(PqC4}QlbK`Nyi^V^_eRTL&IN1qc%DX{ zu{vMhsZ>5rU`}gsB&I3#_;xJ^mzLF+EL(D*;ePOOVf}7!Dn^q}Y&FtSCh7`hS_X4( zH%FpMZF(D(xft2fTHwq~8F~rl#{I{Q>M)mF&)rrn<>|p9NpI(k=G`LkXhbSTUe3c{ zG?zJD%O%&8HA}}xY$GSNx+i^bUt3Dbl|q@a(HoT`BB8Fwkm|RJ#d4V++763AyQ6v>eUgjd zzgx=eH9Wsdy|Ia&yRrN}BmJ0@a?x6Dk1v;-VLmt*$h?`QshE|X%k07yl6SaRcD?t; zOCFzBXUJjw%EjfXEhTAAk<32hjXL8a=*H9|;6xq<3~D9cElT8RZ~EE>N8qvtIWLbq zyfS&&AncEoA)#diKqI;mY@OzJ4mc(^8c_hHVpgAeW;jX=xKI(*0{|24>3`qnL#U)dvYfgIm_a*+xf zdiQ?NXJ=g|)pyamH;kVv2m0pB^Dt*)BQfn=D#ZhRV8>eR97QU=ea%Hd3v-EO4)wQT zKFnT^gkdr{L~@angUw`!N1@d5_QnYEuulK#5z(CWO#5bX-J(=}_wd8>LlJm-R*$;9 zb8#`cjl7F5lA&rJyj&FtH*-DA2haZ?{i{<-A;U8qrE-buN{@ z^cybO9f|D8%%@Js#ryH*(maG-&Y3=_9YL>OV?BaisHMlR zD|vW>7P4+(sSM(EG&GkSXbS7V?{cy3TT|IRxKO5(4_!DS3ZpDiv5eR0&~r`Y=HwE2 z$n!O)7JEe>_&(R=V!01{46S&4+W3<9Ag@;~6`K$6_`5WfSu@JyO$T4xoW(rrL%eT{ z%0n&YMlJNH5X)#^JXsNmFLYMu+U6kac2n8Wgx9G#=OPv`vx}Tsa%m2x=eLkX@#QjU zg)f509lNzjMb~dR&~3Dms7-~kmUVZj6NxjK^c(ic<;=aMTx(Dw?U_G*o%gZcr*)ib z%EjJ&w(|9Jsl4mui|ax^CV63xlYIY&t>w+zLQ$ywV5k*|tLK?FT|1AnEmktrtw=ia ze3kP0{o0Fu(k8iNugsCLdXeXa9)0dG z$2`tLTHY>~HjS9=^ltw#SC`_e{yyy(qb>x1)+m>*5ohuS(1t=z5T{r5u2OY=c5+X!@IAFlmB zyq{0DmznQNr0dTS=#mmaZzzxF=N#;FNh;X?la3E@Mywm3BuzisV`=SB{K!Z`mOK57 zft5HSMKLa~DWwHN8|k0(#pB~f|}azvl(Q1)cV&GpDYGjf0RvX4pUoAeu| zGuN1Vii+yYOPov3n$0n}V{~Bt1@kC$@+9?BLZo6i-=4K3$*w!3Olu zmBfmd2R(h?!jQ<^-e>gR)weJrea2C#zR3ZzqC&9PUxndO8Ax15-c6Gr2ZlLda8d{+ z1(K(mlY#ulm6%r$FHZ+MU_bdd%RMTz9+81x2aT*-9h2%$>@jyAzrHXDA20CtB{y1Q z{!uaK`|%tZjEoN|T-0Y^)&TN-n_^`KIhBs~!CY%p*!4Iao;+XWjS}Sz^Q_Oik*{1r z&XMO=ai$WDa*oImCnvI%Ay~zH*b^1$sL{-byg%Y)W1JnfwF||Uiz;Y%9CndQD%=|{ zpZeRuXXPryk`ufhK+on=BgR+6ib-92^vGHThviA+`7&YF$O!8yv9iO~5skWqGIx<2 zCC~eg%awRtB~A*bIAL3Fdi``NELfC|_2f@W>6N=M#Q|ME2V;Is*8i-Q;e+HCR!3y-Dm&D?8w{U+lMr5#fy!Fs_?+UTXqp4UOGDr}M}?eZ z=4c$+gGM`@v{>R0Z2qa-GAB2)cPxmb7$0;!t`{3zLw^ulL~f z-qR~V%zd1&^L8ja>XG-Hnt_csj3~YnE9<`5BP=VJsx1{}@%vX9Ys9I^(e7WtT z1dkQ}G|~51u~ENwqLW^^Q19XGS*|`%Za2S7z$W=I_<@ zshXmjxpkJ_cKTXftF;p@*KG1z*WM<}qxJT$p1(J}(G7O2uD@j3TwfIRz;ol*1YJSh zIFE$Mmv#Bq?(0hbYM@`zVVrKubyI!#(;d2HtlMm&C(++5Sz^v6N&H`lGFFo$)?Kx7 z*)3VxhpOc>8O4|hDhZmWmN@1BJtvo_Kg3MH1Ie<5z3UUKGdoAAq&HoSk3y5hvs<#X z{>Yr_iyCP^FiG|*RWgGfNNp4TGlLGseOhUGCP{9Qlbp&vwT0htab)kh;U6k#w%7%m zIYXH?mptJY-k&S@-%jiwPj;dI+67OO=}z42gl3&x5y#gmf}GHM19PJJ|7QDt-UtO@<+yxyEaGl-4y1_tKykrmM+%9LluIY^2UH|33yC7-1Ggb~|or8ZO zzd54G6GvPa?Tkgm{22?B$f_HTD?RA_)rK)6J`5(DGcDT5+0KPwxHm5ho5`}bjt@gd z3VFuiVc2z1i8t&!w+!OkC+kUf9))1x>o6>D8wRySIGM{(*q*0@qOTIq*tfniISl7* zm2~{jDazNY>(JxKe!*nVP~2^z#AwbKL<-k&SJtSi)2qY#eGu15)5c^NS)+f~hjWsJ ztShLQ0TG~vcNVk%x@&R!DLucA8mw%@e)e!JPVm0tmPl@~4{IXBSR*N-ua*6WE!_9S zepVqOh1~i%?g=c_>`|!E<1+VQV>LMSo&4hxW=^-!pw)U6mX))g(~UV>?CTWG%E09Z z%#cpYgzqb^#q3us>z09;l8O93GBIl_x%~54_?W>y^+P(P56~OonuSqIvM`o47~?+n zrmJSbHaipV$R=9d;~c_i)@NADQlH`BiK4oAo@99^4 zve3^16

k(3eUSN@wI2>xvLzU?kG7;9mTIr zYq?f#Ex#T*$w1bd7p!)W?5_4=H`i6}ZnTwjD+l@2+fIgsImyk%E|PGY891vPWom6_ ziLr2!PN{Cv>ye$TUt%qJlkH^iTs!${XD?BG-6hYbjZApdTIOh(L;FgB^FGX(Hdi3! z2KhymQ5=?4$k%A*PCr#((gkvk&FO*jP~Z^1*6gn%`Da_H zv`kQ-`X2$PwVRAofgf(A1R#L?;-S`o_-j4;3JF07@9l>X*ZomtJKZ)t>5Y5thq++y zW0^my@|myKOlIP;@44fLKfDjnXAnXUV^g~0d;`$pOaRR0_+#^YKj>opG3=)==UDyd zu?xV!$^bkgU)8DDANx2H*u&Ew7PkY)Q?UOY6U~_$a!`l)9CeqTx7(aMbSF#oo6g2r z(YW<75>hL2!P-p4abZwwi&3O=VQ`E%7#INXFj2=Z7VqscPHvQN>2z5ieI zF`6*ns(}HnEtsvhlQWWTWT{T3!oDND3?0*O{v~VUX3WdoXTXfF?9G$Yn&Lt?!fyi} z_cmbAs8kHRlZrpa8(3#%jqOY-`n0Cwrg|!R_f5sZe*77Espz;km3w|>cNB2mEP#EH z>S=Ji#q4V5Ja{gkcX2#31lZ$mGMn7h`8?PSW>yn>ImhSbWBm^Pvl+9kN|=Gm{zVsC zG5}#kvQrkT=|!kX*Bqbs{j&0~lz->OOuoK6 z4+;EU_2=i|5r3ZQaX#wr%twtubSZ4L5xL6;t|9Us>79s~_(2>$|Hw`|K*mH#kc|RePC7Zt`bOH?iK`TF#UGP(F5%m{uk* zl$gLf-Y9FMjk5cy3A(x(WgdI@hWG3fRVDN5P%b`hM!9*sQp$(Z+sNLL?N$X&3{+sL ztpZ;cC=m37T;fn>eYIgLt*8IZT#9cdYY=b zF^|*U59O!)k+wSk6+c+RSnH1vZ(r71{jkR}0Eg=a;>lI!WmctM#fE;T*1l-(?}xr) z{P3iYKXl#wU_vh0PwR&U!~781pBZJWomj2*!@~A{n6@Q~_g?k}XORQuHKi!vtn%R~ zZ09vIc`SLvEM`i3@mhPzEQUX$@fUkzQ6r);V@?#ZO`|YD7X{aNW^iUpu}0Cm z4ttKHqM2L6evy_LI}M}Y#B0`Ih{C>^{5pB#F>RR_H-Og`|NYZ;`cipKj%DAgeo`t{ z_h3d)ce)u58PJUEp`|@%;NuNQ=|z_0oB>a!F-w|!A>%2(H~XC5 z@8%(b*X`@&%4^oqiaFFn>1;gTPCv2bV!dJALEYo39=cOUPU=jy z`{_rnX{X=WZ@1^!HeGdDmz(JtJ$k9TTd%+FpKF74mg?%gx}F;5x$x%H%RlQK*VXfN z*45m0Nq6_tj?1Zk9oMDYZ|(WVkq4gd!|PnCJ}N-Jpyg!VYUZ!f%>YR-v_kO zt?2(o_pH@1-Q%uW&vnkrb!m~`b@fX9^egf>ccMrZ&VF+;H2b6_YPIpwx$kA%) zaV}BT_^2hKmr8aHQ%n1oYPsc~EHn41B<-M9jOA+Ce>PbrY*I@DE43t%e?0WkmEL|g ztTND@IMf9WMrVv9^AR89f|Zk8@VW_epmQBjZ#Nm0pPWyt?S$dcE*Q(#y4+*$rjH9+ z9&w`c)EVx-oZ#M)JuVAp+-dHDT7Pq9MoEYFIVXI);|P5%@{UhA1GC))3w}70i*Q9Q zXSc>}q8Cc#ggP6YVeu^#MYqGy&?5|PbHnh7J*mx?$eH}5WR?gSj|Oz3EK$Opd$&W4 zln5dp^L#gX#dAu$>&5-z6*?H%+6#W~bmmu=@#pY0mfQI}x}UX?-Sn4n2Il=$x>i!?W@Ihq z*I_!mt?B4y|1JI+GZDD2d$);y7Bcs9ZWgARlO;*aLPhN?H2O0Wqwi&+@fmtzj2YNw zl8pot&cJYgcxMftj!41@}J>Vvas-C21eD*!jT&EJRacdDl$>yeFpw4}8hTO;&t!mILK3(q@dSy!x)dtNjWT_g0{?feETN zBL6_HQJc+q4f_D}>==l&#erx!!Jiq@fmrjNvlfVkSv7iVo%V3v~ZETv7M#G*$z@+ z;v^OmTqJG+9TR7`f8!by+s70`-)lR9?{^eat)uvO(h*4qSl}Bn zpK9hz_oOd!6#beOfr#i9h(Nw4&+BA(c#PV7B7;gEWvJO6)>@fsdMFCDmXO0JjKY)z z@;h_s{?gEk$bH@E_hfg%({MeHzQHdAXhJ6B)sH;1NGw2G9xMM#PO^EgqwF(;(*r*okMo138=Z*F1F(gR zOrzo`wBbJYU+ZY>qgV5yp7S@?*=J~xhMPOmFn^FhigS;3BogrAWY_Z-)e3&H21j=ZxapY7_RYE_rSe1`5m68np}@9RvNHl zPa59wYy0^5sUA%RRmru^jJe$0bN;)DzN>X=nNQy9K0Q)<+MSSlqmN7AbY}Fdbi{z^ zPBMsr4$rUW9N1xO!a*d@L z#I+%tc81S;1L^jkMz)|QvpUnr8EnahEi*~d$qrs36Bog`+EY6fUj6Tp2kU-Z%vPvn zS9{huIws2jzZ2p%VU+m3X{XiGyd!lJl9p`%We1 zMup=7S(K39bljSeO9|9q{&Di)?U{X`&cw+5%);qT&lc}r|G6U9l2IARfa@OA!TTZj?F~k*9PmsO8 z?@E6#>kIZuoaBAJZ^v+?yd*1Q8;-R}8qOVQab%MgwN}#MRFCYSg3RSh<`#_0=4-Q2 z$m7)MN*10Rr-P7eTsup;5RcO-Lc6v4<>eIK?Dhr$QGEt!=`+0@gs&Dw7D#%zi<1zA7cs(JH(W}2k ziv5zMR}yo=xo_yf*@%=UWHCCqpjrtXS8H8S)RJp|A2<9v!4=j%WGX#aH<>~&a_w-K zbymXRY&fcTYM{&FpCCGl`>T;}qD2>XEp#23t-6`#CpQyg1L^(xhyI4PSr{^g+0tZo zzH?SPZJ5H#_L~vH-1R0>wNcv&sb^c2(SFILrj}!7q%j!UuOD2t?fleoRr19ATmv} znK^qS6K8gj`5e#8a{9;4_ELEHI-7XCxTNsf??m2-@2B8FYw7aVMLg{~O5%+U(jv-P z?9RH0?NkMt&#I6X%}p?Dd=(T<zC0Fy?XfLNl+mAj19yaH^WRegFm*B4EKhRyE27chCfAA+(dZq;eC1yTB>ynLf#(;@G z)6n)l=k%-!puJD8Zy8;_e;05zgU`d`+~lL9vp7t2l$u_4%vN@giMO2P4Ee3*WcQ&su#ZpsKEW1AvdsKnYPYlAXM!YAMl5hMFh+Ew_1E$`C69v&2%=h)|RupFO zPorQ1)Z^1oxtf{N4r#E`8eqe(b*jU;z$0A4p6BDff!_5^1;}2@Jnkl(-<#qhS&1Fw zkDa#S5#%B|o3_#?P=Q3=qc1J3kX0`fDB{}DDnWr|#eT5#3BairoNwz90Q(SsY$y!i zTnV!YzeZzv5%0?vqv>{!MrV*WzhD42#kl_1KqpHYbbMx7nViNvwK59GD zWf`827_RfaKcudyQ=g)n{^S4o4yQAUoISsCstap6na~@|q z($mwB+LIaG4f(9JjvmBcoYVB6>+^LU#>D3%(%n@Y?8)ZFwv)@%U70`PE`7hah=S{A z=nMt?8=D}sohgQ~-eu8Pfh3(j;wA-RK4&OQ&iW(tSrE=1@W+_G-0zTQY*Z43y%YAJ z!Sra9HQR#=;|$2MO2ZJY>z#X~p({U2ZMn|RPRhg8-~!aH#d=7;d^9+bkINPGGaXgQ z;Y^jN`l-aUNwPGmsutr8y7s!W2HndUjV|$7!GsR?0WQeY(fzlAJpKyu5!G7DGCxOVX#bSRb?y-O5ctyj_q zOO`q?Sm9OUF|Yae3NPy`8oA@7l|d;dq~D0+lHzkhs*^c?_SOlt+?|<4PTxGeh;}({ zSRFu5{dgsmF`SjMQ=;`ku4R1gsO!LcbVn`XHquucph5i!8tmJsLHcqH;_op3<}m$w z(VPv~lLaP>U&&L+Z>nJ zCu&h$qZ@LJD`tIj;U162CzrgXtt58wRg|=TZ zGs`sy9>STZ4I12w&%}DJTUYqL3ZJm2Ixma$$80o>Pw>?9tN{5xPDMUc17ubeGJ)^=e53$8r=8LVzC8h)%fi5 z*ee?aVSHYy$imjytf?Q&#OnPDubLwiUYU(dyu!Q`UT4e|UTYUByoNa^NzJ+%Y0a6E z&h}dAk*pDic)C8}3X2`CcwNf{IvZC^h;>2EAy?cICE`Yfaqct>^ZSQmR=>z&c_h}eUK=z)`bL01BktxfB^{)){Yr!lg`i{?$cW@s|N6QMX z@d4y4IZyF_pTqv#)k>C}DUv^G_+WH)1bPh9V?q=;nnzZ09D$y;NR5 zC#U8biT=fUd<>-jvA=~Bg#DCj6}~W~FYLEI6$7s4;@V1UDS22VZhSw-yvXH!rJu_$ zA1y{(OZwUp3A*EraYyL6W8Es`S1wdb&87U!Pw7$Njls*9m%UYw*9y+L2ARpU?ZvXm zYy|#l9*I7KSleYS$j_0v$yZC|)*^4XHjTorJ9B!D@paZ~7d^iD;^ z&^&D3VJ;S{%Vg(eALPBDH*kL{V#8UR8q!GG`&LL@8z0o1$-4Pja%7X3Yuw&aPR}oq z1_Qj&fWOz?7JAGcNMGSS_9#{r%e8gP&rOQJ#?|DocpSo4w2-1*mC`iA2kkr4cUD)A z;@!E}J<3*eFH7X*zuu_%kn_*Kng8oWFJwS-Y5J@}-YsD6OtnbPSnClzHxG-NT1qE! zb2T%WYaC6^t0TRB4tbo9x003f%4FS0UwocRKJJ(vQ%^AmIn`Vq7L>@C3EuE2jldFD z=IUnWB4|}p`8l#gmL2p%Ok2)ef7Zj}O%9#HP38WON{Q$B{kDpE;x_dCz01XdxK>i1 z4*Eo$FZQ3OBe)i8^W>Noezg!6@_O5+`@m;IBwU~H_nk;Dz?T-H_~(Z_{pN$AX%SF1 z(c@n8T%6n6TxJ#(OX3J}tc4Mn=|z9vw_MyN|5!=R%MeRG^jRcAtLkAWWnOj^`%G!2 zV!MFey2g=+Fw-N9JYa#3h5T7mB&h?K7aYfYbJjK^ALsJeS;{^smawLNI9i+Q^)6;I zwP$Yf`bIM1Mxpe(=8FqAIqywAYfRT%==(L2&+W<8n$ZX6#=LKGWbuFJq3iO7VrO3> zM?d=F%eDwy{h~v&wagQ5M33ZbW^u*%pdWK`*EG=MYb-h0dUo=qaiO@H`e56H2z=tt z4X?s^vj|%m+oVX$#Se3y?nVGP(8pu*5PGS(40QM{W3G%q@h;{I*Ga{PCV4n8ys3o-3u)S@ zM7n$M^Z6)(b2#Le`;re0vyxZC3gzGdA5_^LNxwdQo%_k{4z`r~yGvytKUZ}}N8(Lk zDke_PMbQFViOVmM56p?a6&Zn$IjQg-$U3g7x$L0R;JJaHpH5L|!dmh1j2yh5%g=vl ziS!=oi>W-G!>j4Bu}&_ZY0Tt^RjCB6;rkgIflCHGa*y-t))wM+xLmdc_;9v3g1Ir| zDBtt`;9w2kc&3Q50!rKvdQSy|1yG2D^LhTqW%; z7_ftqnE~u(hOj#**IZk|U6YP;?f1OSIe)8E_xs}SWuu&qOka#~5Ku~eQm_o6E^3^&aTXhF``Wxj)Ss#_%echl4QJPfmr8}Xuk9&$UF z%eAp(@*>6yiRR>IXQwdNg`UKbEu`9o3UR%}{I)h4yx^K`g%vr$JMAUoL$O?b>w$wG zH8@@`6;3B}F|t}~=28?(o7tXl4-Uud)+reI7abUm&E;owvCI%JOgJBo-dl{=%(ErC z95V@-Stx^&ys+T!FuXWrM6Y&vsA}6r)@>=3(O*1q$UY1WLXC)dk&DUXE_3de%eLuW zbb|9ff0u%o?tJdvw3XjJ7R!`V9=LcboLOi_Jj%*Nhl&=Gm{=;q%{?%Z+@cMy{{ZiY z(B^F<(yL7Vtm}z&&f%D{+lZ3Axy-0(E1#ErmvN6gFeWn$_c^ZGt<6P5*Vb}jN{JlW zItu&$*#n87*Y*BqL{DuY^{4PTwerDOJ{O<5reKFhE*5-=5j*mOO)mz(W}6mnfF1TN6WoH8|1VJ#I#!EvnG+>q0g@L(_v|5VF%Y= zt1&E_dCDs?(V2ZLf7XkU>I3cZ+p7TB-_hbPn=G7~UWLtFj>*@vc37RV8mF#nk@<iXY#U2|qAUG|taThB zuUCI|w45Agi=t7hVK_!_oo^Og-KyZa^O$USXoq>_L1@rkhej8eqq?LL2#l7SA8p73 zkmH-6MPy+Hid`yk{zHs(K5L7k{^W6<#^Yg4`Y7MiA9tKN-J2b-=w<-x4)NGsoQbXc zys=)i7;n*!wj%)Az2uC@IiB^a#GyGy<)N(u`d0=*-%W>^%UBPl8(OoPp23dv)6ELR zByvxiLNYPsXBGaLA1xV0c33{1*-5clx;ZlOY#sfE;Zd?|qAfno4u(&CEn2rGr{+j* zj{NCw!M3c2kb~Pzk0Ck7fmg_xu8x*~TXq<38Gx8BT0A&Qe#$^Db#|<{=#+Tt5`^dl z^f126!1<_3jPZ&U9AZxHupo@{X2wPoc{g%Qixx#oO?oyH?*^kwo)-JJWnvP2bDsL6 zvW>aGQ|Zt;K|XOg8HldaDsgXRlq}cV;Y+(f)SRV71HPY+<0`RY&{6rwJl~$oL2hUr z4~wz%?tLbg_w1O|9-yRWl^#RBPJ_YZ@{aIza*s)Z-WJ>51fnV5pFj}`>s%~Rh0{Js1^KD7P2XmKI; zS6UW`vd;8c*2%<$R;%)l~>O5hL!cZP1B7?@_+aD(N6EGMbkv!U zBc96lQ}~?T=KViCM(*(a%)b)|%L*-7XWkFBs<3?-`Ntae80XI3svbIi{|xdD{JHMO z$>tvp$XywP#S?iy&t%R!@5A+)8b;X$zLtq^aFOf*7z{k zaP&Y2V}z={F{Yu$khkHGq49=ch8g#JxSc(gZ5Xw|%D61CJb8fawdCX09o*h^?c4il z;10vcWp51HqjL?b|Nhv3*Nz#HIM;F$F1~%5p z)Jna8S%vQ=>*PpDjM&eLllHe_#l2smJRjspcN+UllUYNzP@>d>EaPH2ba{mDv|eC38lXyK0R{894qDj^gQOoJK+9ix^f$^U-hX20!K3k#GN&a93`A=m54j% zKp(CWmc5kN-xm;uakg|JV%&A&Tvq-1Pt?J2H<=>n(fu0 z`DGoBB=USAi{qmu{XOgTn0Hl+_j7fuMJJ&9V`fO-*Fpc5=hSJ;vR+5;P6K`fl4~5V z#nRz=<|5MlJX43a)0k5o$FpnJ!TfERJH3Za#WZ?yo@e2BNEW7j$->Jcbh>WL!mC5s zxJNc|Pj(jjII~ecgJ(VSvk)7^b8K}sV%p~50_%A3lj;85orTK^X3{s$LP_%+_DE-8 z(Df{A`7H~7kK|Z?l=)DxJhNu~W|wys5;>lCo=NZHiEKC5riFYwZXsJ()9w?cl!g zWTTs%v|?YCO;a2BKG8~EwzZNPMJl;xZ6}L&*vR3Xw({(Tqcl2YDYehpOJZ*a8R<;7 zPoz?^gRSLyoQ-@P<}69CI>^=`72>Zk!L#f#i5_1j4i^>3xvOBN4QsONOi;Cx4!Bfu zhj%Na`8NgZyD6~nuL@Dqz4-gu3VBBN+!nJ+xv;xjX8S9!1150kP0q282^L>b;AjVO zS~XaocQ2FK+>e-#E0?~*d4{^LQu@xQl&)#zqUu#8C7zWMf0F0)K0dJRPrfk23)=c# z7?|RXIdkaxIpm8Cbm-qL;J)-M`|nTr;L8+dDkl5jsJS;TW->qb3|T6&Rz-WgQMS+< zH80b>_=vd#JDF3>f4{ihhb)8-^8fZi>l!>0xaN)fbG*@JEWM4tm_;4ToU0w)$Q$g1 zN#{J#lr{R~6b>FrND#4@Uzxa#sU+e&a}2&rIfUoJvKnL#fO$N?|q{8N^EFHzlXyuSuy`%0H7- zY1p%ceB(m;bB3nkg?kD%7jtjCFBM<-F=#q-6nm$lU@pCJ+@l`i>ja-o#q-U~o*tiy z4Ru-L-s6Eo~;R@^QX(>1aer^E2Peb;U&d zn8#kAeE3=AWA6Dpk)YCJi}F}>+$ z9FvdAeRM!NILYLpwz6WnQryfer1uCLsjOxvE3P<7?^6!+Jl&7F%-xnb7D`FcS<8;P-q5=ao{>z!VRy6d1R*N;JWh(qneHM4Ff&ty8&tZ$geZfbIx##gAK+$^q=mq%ix$r`tG7k)FDXD(-lrv!f51xA8`ghx9WtBj?*=auLbia5}?hwVp51 z$NS+t|E})k32Xk_zO~-;8u7LGOgxSc$Ldw#sNPfqn~UKXGm5-nOAXQ=Fhlw%&!Q^G z_XdO`{SQ79jhWFEz-RBX2G>{9J9d-#?#>#t`oOQNsljgQ_P)-WQ#HB*ZbIex`Y53+x=45dyE?!|j`pFb{ z%}&L%pfuDl(A}8An%RCbz~A^>c1nZgN`8;X6y&(2VsRaEkG5&3{*-^enu=dM*V>lN zj3L(2_8nq9urA#$yYtXT%M23U>l+Mtm_0S0H4UD>eaXiQV;)j+SPwmrkA-wLmLH|l ztWN=sexi@+FrS~VbfWT{cUy~m1n@b!w3%L0U$Pw!*;Cqv+|oaJ*m@x!%lO)QKC4!I zHc$Ux?)$_7T;9*`-5?KrXOer|@VoJbwrO&gGj|Mo53My^jPGb{1BG!ISU@`X86l6uKdMYo*9XE3b~ypEyd1Z1(Jp*K>_`Nr}k1 zj(A#6iQ6^~P#4?dG}m|Ct}0=sP$6On`&+g;;sV!pu5;{>HPaqBbsSOZ!ffgN|G5?& zkZ0upH##b=M=G%~+a5`A>}#Q`f4ivz23V1qoJW3fl@j3pTTs^ln^kT>kkv(4$jNV>q>t_5^zbq}E*KLnT72SZsi2=-hP zn);JZnG=lr+8}H{!p~I&GxH$?&7DI~$aQ3khe3$HM|ZbVFbWi8A~*4MdjHo;8;q~L z0&(CP-HsLPZR2YslfU^iI03HfbT~a-M<<*Xp}~4gb7#*>^#nAv(lc{Fk4IJs2^`Bf9fGa^q8E;ui@WqE$KKZWB+SLCJM=p3~;Aw@lY22?3#^avMetA z__;j`fApfm>}fUzbG>)(4*OJoWx}#8nMHHJbf^H;lkMj++ZVF>iXW2IIy@piK+1f=klqV^70#jyq>}rNP%DjpqVi z5ZkW+`3DN%IFyd7reEMuo%x;P9A$v(@6zd4M>(PDBy&33i^ICkGV>(+VA`2tJvk87 z(rWM=SSjv}nTfs37YdI1cVn4b9N-I|XkWa0<&B}s*_Xld{Am*+ux^J2V;v)*;<{;3 zRvH>{{OtCX=RlquKhLG&!W6DSoW8(+M?O|uEI@6}`7z(}F^){g&@?+)@J%V9>pIH( zx^}X8kdyd3c9L6j6>wcn&(;J5e(4qTW}D!ujR`v0`Jw+CU(~ARk5^lm)w#q6u4Luh zi#2GogpO=O1pM9Tw(7)dyAc7$X{o5WDveorX>i?`hHUZ}TgY4<=v9Dj_Y2TycL9E- zp! z1NH!X@kWRJez;0+<(((=8@u^nL?f;ZlOv$^j6f0R#w@ax{+zpf_b`jHZ#sfGkMtrt zQ-f=}|9HK@ngZ6c3h?@DK59?*Ew0zNt5Kz~OJRXBkK z4lLq$8~r8(y~0BAYF{XF-iDxaY6#kELf|#)KgTS`seL;5AEZkvDuMnI=G~C{ij-`$ z*vj$5F&mdwaEwUIK@GZ*zRgjn9d?k7Tf(z+9~1SqN`<-9mBuVJLpGZ@Jl3)}}6U+?&Jw z@L$|>=abvZB|})GgLh0e{Fdfm5pyyJTxG8EF!CT_JkKYe;_y(R?nUmQs+~ezm;7LT z@&(@Cbdo@q@&3L^a^_T`bf3$tie5>Q-qwlh7bVsoV2mR0?{9htKJ3=v?qNNik-xCJp+{Q_J-(%qw=8Gg!4&eHADE|1_Tq34zE65) zh?2Kxc0-{~-b}Xgu0riQQK4Q^%|u;SeM084ub^LiqRgk4F?MpIl$vQJZXsRAACzeP z(h&_gKjzO+p~W;M_OjOT>P9e9hq690C zSTdG#(Mml&xFuj_{{%E3i+cYqb79D$e2&gRKsb5$C(MjkNG9ZT7H(QIf4jYjI<}RG zdebC@+HMA~XBF$lc4T3@>10}$Byn_$muenlW;UFVX+4!FzUu^Sx)Ot&l+ZO-;m$%Q z6n$sCH75k)SjRccI?$LjO`8Nbd%UCw)X*&&5`8NFoLn>x$6vM$nQxUD>HM^^5jqvRjy zDrTn?_<2i#cYl~5irm4W=_at(m|`yX-WU4%u^voc`~qKSmiwanFkjqR6hS5{0`X_a zFZYN9xR-v~BLXhp$tq{Emneznthdq-M)pfJHkEu*KEAU*&T=_@h^NTyWpMr4f#c66 zC%HDLlN^e&lpO96-bOVSX4e zlf9CCy|DGOF9xt5YRK*gSa?NX#!Ud&)@eBU@&6k)0f$&poRWi_az~ z8(JmPH!E;{58tb7=3cMzVQ!ZnKHu>{=1D*7S8?x^!u`|62%LKqf$f(xIQ5o$9FEVy zVPqFMe{JN)&%aW!m2>Hpt?3v(kZwlq2YNadpcVTRz7EfaYk598u2#z8!Ol`TyR%H| z>m=`6bYWe|S^74tls5M&MPoysCi^Dd@*`t@m1KL<1%00T#$$f?hn(kKMvwL%1kI83$zzh19Iadri z$3CoA?5S#EFMEoWa_OFvRO9}A1bcl)?6Hv`&RrwcD)1($LeiI;pm>o9F1wO%bn?gQ zC%)M7yB|J|rT2J+FNW^(#b*uoby2*QBC@APBQT>auWupiIP1Ajo0W!bozu|wDCaS< z`E~8mU|yGdr;`QDs9+6a0oh9Km#)WTRV z$m7p6!Czfj|0-7CV@DGVol2gOuI%{^%nB*zUYPxRPO~|m?TNra?rY;7lYuQ~ZRmvt z1>GYsc5)g9eqin83VTiW(x=JyO3693q&waFl?6ziQh>panQ8Ha{Uxk{SJ@uNTyV*F#RuTthzYyh8nJq=|Y*_2V*fO1wBt(8;+YC*|VClQJ_! zFK2#tf*swAix#ntzmUCW(^;E8titd6LQwO42&VCxBKp!@dpZP>3i5+XIUWz7@7~+6QHf}L{n%;6Q>qi%19JzeX4?pRz{40Q-W6l$WobOXO*AHNS z+}O8z*~Pu*Lb8?{oKMKHLkW^(q|diEy$9@@XwYAYjCV>jHC3TjL*^p!{aCOp1hzJz z==OuYeD2$xfG)-eG?bm9I?p7iRw;&B5GdbT5<9-K^tYuL1M0TV`YP7=?N+@15(M$Lz_%UaoDT zuFiY<|L}~XyIY8@vPfdDcwu?1a6GI}_xB#=$n-ap$m50bJ3V46U$aKF!idV|xp89c6QO-Q#_Ib#5F_T)03&mlaC!&{yBYF;bA1CrDm1fdlXNk0b!rFBs z=EMHRoYO9O@Ne2drZ6YE3w>wDis)yIWlnA)`@Gk;mBTd(<)xK7UCHEqcBkOT**vsa z)lBBnFZSmkPo#7U!^$T{T;7p~PrEwExe2B6gRfIQo*W{1%yzSLq4>SEnA9wh(OXyx zw+_QK)}dBz&Sx*JjT|Z|mGsu0=#UYP=ls6STd+^|a9jCzWRbkS>kiA4VMw{1f~I%K z10FEv*;=XW3G||~I2_v?Qqf{&F3Ooh9aF24x$3ODE5f1fmV#Q|tm$U9mB&11_?+R1 z7hA&6m0ra-b8?+0Y-Hz%5-C6C0WCSlS<8&5bu<@~6>X%>#Ug3<$rD9U;duLvJenDE zLi(7?zy9POk9cBKGYv`$jkt1|ee@>QGB~S5w)dy6Ffa^L|46}$i_E7!)j>vwmC9*y zZ3$8I04^}%W-9rnVeRG1y;6xj;fYsWI9F{Xm-mL8-RHJa@~lKcZ+f5=`M9D9MzkE4 zi(SkSeppf_XaDlTd0uDwz*H25u#VlSos=1V$+F$-^G;-LFMqC*KXXyT#ZrciES2Zv zK$Y~?wV{WxF8hX!JuF2PUqnYdGo&^#FZhuW1Hb3OGq$x%EG-hxL)@S4B;QKTaZ=f5 zoJ+Bi%MX};O%7|ST{!C8Frdd+UJp6hG`k83c}ni`MHnvRlfxoMIl7~zZ0N?d!vrrF z$jOHA{jvV^85+A5^pus$pxIt{a4-zkt5RUi_tT}E_w(Hn>DI*qPF@3S!olmat$+|qObZ#eZZ+SmBk(=Z1{hN6TEO_2ga?)I;%_@_%tJ&Xime+5` z=U1DHpeOBQUrvb_mU$v#CEXPo^1o61{~v6ndv1wbY3zYSa&STQQ*b;Yk6tZ$1GVMS ztSh;>A7RKLC;R>ZJ%BAc$b_cl@}tCq4vjFhv^8P?*OAxR6Zm>SsqA(4z@=Dni`!Dr ztOdF0FYToBgJS8~g!$br;qbFGqM0xKl@rWF-?KHhJT zEWPRlO%3`qc9G}h_Z{%Cjo2iY%8OoJxW;kjVO!>m&(346i>35-E|Gh`=s)GSVT?DT zoLu36*H)6OB4@YR106?)V=BF$(TY5@7}Qn{q?gIkV;ryeTx^Im;5R-;E$rHg?PhtY{~fmzIe&$GvqE$TKDz@#j?L5Pc*s*`i3Y zR(WG1&(*$NHsIv0JUU6*$;hGPb6fM=gPdl(ixI}%^i-BxNQZ8fQf-?jc9I)iy@-Cv zm$_)!tfh=otg?j4Q=wdnoy%tcL}{T}i9CEt&G;O@~d)IDcJ)TPgOd9HILER3@scyGvQ*YP2^!tGvC?9+JvROdgg1GdKID=bOs>MdW-+p4 zqaB7!41^PToE~AUsro9^frDeD`(is--wQ?44w36=Rg?XMW%202 z+VZLmm1sl`v2d&d`|ShpJ~$o|Lo(5i{T7!G#>rF@J36aYqc#0;zrJO_X<8L-XC0I2 zW9%@{KLCzL z+F|G6Kx`#1Hu3jN))lJYyf0d&40k|WVIXR6(!psn`6>P$3;8-4l|3pN217MW3wu>2 z!tKbP#zsr4*37C}NnUlD79Q_1uu7^}4~><)W=fpe&m3f9Jaiv2&^VaAoAkIfBj5U! zez(-Oyq_Jjm|el2*EddL>)W9#f8NF);_*X64Pqw7B+H2Kvoq zzV_lMQ6ICz^TGgJA5X4!Vg?p#D$)K|jO=@Dix=uZ42a`>sLDdUnN?8tix^gy|a)-zut)c z$K~)Z8+;xfi21+b;iJt&M{=4Dbz@{zb2}`UOrK_YJYBEMzb>XOYs z(toBcWKs~m7`2!~&uOn(^gjkfOU^-ixYi1ULufp1X)~bMTZJh@VkLp&+miG^6muLK zS&h#-`QoSd{yP`6LCg0+Q0H@;?460S$_fm77$udR?2wqX8hv=3kE%E>@p;U$i;-5P zb{M*YnYlgb{XCh0LUN;R_H#TGdj#-(i}a#*V?qYa>qTi^rO?w)|XyLdSf3r+M!)1 zdT*C#vA23A1|6=#zkkI^mmTDJvjX5#iyjYpa-XlM!t>s7;(g2>^)@jdoc!Qgjx(EC zN6dN@ClkHxVP6@5iq7Q0&(q6xs)~*-a;!#M^d3sT=O}WZ(=u`I0N>A!u`+VMEt>Lr zCV%2{u|E^-8df18EJpl8>@boX4yFt%LX(CD?x)2*pvM`P@v?S_o@ zwT$DvUM8EFM;huMS?6YIJYi@w+tuy#q)x7d2koys3q5BDe(i5?JiOG9-?)a`_gAHc z$U5H)^INwxSZr%-T&G)WsOa&*2&`6bmY*lqdXcdArjLEx)oM1U%GPEaVcc( z_r2ROa&xOr9F|HjGZ zJI7_!isN!XwBlD7FZDxX#rN%TS!$(~6LWMjC@oe>EO`drf*zh26&`+Yz)03Xn$1z- zUmtpKk~`w^6te9_^a8McbI(NukAGCm$WM?y0>v4auevzh!{dFBK|C5Caob&$thk5Tj zPk!gdnw&ZtfAjppbV?QuCuMOQ%EFmVbPe$Qz`t4!>b1y1tK0myD_Pja^Nr?4_I2)N zE$vDszAVq?zh`4*0lf*V>nnIZ9de%hVjMZgx~!3qeKgGE*;PCC?T*Vr!B>8sXXb%E z^#5?~YPGt(7;ZaB`h6u9!aQli$I zAg5G;^+Bwycc_%7zndVAxwmaTSI8y5axz|(QX{xRCM>8DllUrWvbtP`gwqqht3njt z%VgjmRrK~(NQoQI-RCH9{Vg-BPn1cO8SB1d6=VS_#W1;2+B4_c&a+(pY+Wfbu!!g~AqT6DY|^ntaLA6(DT?Rd@)6Kne-u{!JTTYQi@+#5BxS7|@V zAB(nlqwg0VuGjq#(TCpoS);K*5y4Dn4JvSIPU4zjI4F+{2 z@A#0lpRpP=U8cd1U94A?(78xnu?Ej#K65|#4?o|%kSqb~`{$J!EOjNX<*Pw&@{bi~ zc?J=rfs1tnj@m___W=6lcJOt!vF<)Bf?1&&d~C^l-S!b!(2-nKhg9V5NJZaXJkQ>h ziq~CJF)l6@o$^yK;XXO2*D3h2iTz?^AD6kN;YkHEOnytlgjMtlS*9Q{lV=?fny zJ%#7U`M|3@Y_iLT^}Bp{4PsWbZ2{{3l@ArqCD!+4?Wq_21|#TK;yH?4Rz7|omxn3j zr{;Ad#~4ShaY8^Xz;Sy=DGozdRh~estRm@>sj+ z{o&t3GV(BDGqc1R(c{S1vEqL6a;Qp1PP3NjgRR7kz07l`*orr~!s9*3GHz4KzIS}4 zKHACc6=Wbb*ocf*$*IXIajfqo4_;VG8u^IdPrArOCmVS<*j7U3wUhacY^7FDM|o(c zlG7jTrE6PDsZSqN+Av#bIk%nc$Y?K5W-6u6C|mXeI!OIQE1B9^DW~aa?6s^y0^TUl zcRrtsDHUS!vPv!`C=lDl1XD(t;#%t}c{aXEY%W*Go;u~S)`nS~-z#L}=t>FW=a;Ri z2E)xNX=70-m#0>U-l{^{^;2N8wnCoj%4H<~Z|4bBGM1mu{81uJ>3MwnSb;E4G9{%Z z@ZrDzeXUZC^Yeddcn-9Xyzf;X_!)gM>W4R0^87I5Fmv5LF?Yk3XNVWbAM&|rtY*IZ z3LiYE@J5=m7gq3WsL4?ublBhyL#Q`<)tI}HNx$L-AG9g)LB?SE8(*^)(2Lok8;;`%;mpF&z+=A#Te!Dx2n~)-p}XpqhI=bMR}m2idc~}1K3fVtqZV-* zdLdbpJ4ycHGiw3b2n^3+^`GXIUwSbaXn z$NJ`B&%u2Bm70$?ANgEo=3(x_JX|s4GIxuaa3Ag%cADE5x_7%~*tj^+psser(A4^s zYlz7xH{JC{$t`kECAaf$V%%P|J$b=<-%3+3T<>^I2R}WbC?%aKVG`U$4j4!S~+<$R?g3e7hgx6$Z?$*cPU{pMulpY zO3Zv`kIA!Dm_t6MU_KcOXBEaRwMR&aJsu3=+A&m#TVYBZPgY`*nF_tr`LzeRHay_K zQ!5ANmn&gg!TeLc&cfYFm?!Y_%b8F1Mv1Zs4sg^fvCKk+Bxfh=`BRCn?RZAVui5g! z9<|;pG3S*MiF-rQpXhv z%6~KRtdwifo5zB2k>_7N*XZru#P9n(6uXT&Y~^}wL}&7a;X3@>^cA67Vxehpc^M z9J{c#P)~=tdvw@M_Hf%V9cJ%gX6Zoouej)NErva!m)X1WMhlDA39!=Zm{+fZU6>v> zuhQRGhk4Vv+_z=u@wbg0kKgLpyTf(hb7qy;>9M#=0v7SC>%=)7(#euE=$3_kt>|UU z&%(@kWDwo5kb08q!@+dYG@+}JfB*MlHYWDUf*skL{O|N+)g~L%Iva15%!vM!N#`tC zlSJl9A0eBg=Q(f>x)~>AF?I*a2B7uoj2M!M88!Se&;(mAJ$%rnKj9o6V} zrss-h=80FyjIZ@WlSw|fPp&cdj4$*v=(2mDL5tdCyW2&w7c~M?CvmLfm~={;ik=JU zwXm=;t{$_4&FHrx6W5q$`eXJMpm~o1981f`&w0$p z^x$0VZX+I1f2C5s#Z*b=#!9hSUnR*~6v+KbADFEP_HFRP_XU2iIZW?& z3qMpw`6BBCGnUE7*piDodo}`{awCv&GZJ;Caot6hU|S2i8M9MiHa;CoI7T-wP9-m1 zfYtwU+~xc7?q?qAZZ4oFr~p4Fbd=AH*>mKml8OQs(OIjc#`#Wix`1x0am<*0R3`Sv zO%c`B1Y--UWKdtSC`Xu~Oa|k!${(2LhmtWqu;84vKaA_hDa=wXqBEG>LySb=X1`Pn zu1)@fbA%P=pB|p+7}AHoJH8hYPsn?&&c_EW9apCdaB3ZUOYU@*4?msd>0)PbYt~UB z>d?D&xT6fYX^Qim6gYCJQiRu5AI#+Dy)^Z*F9z!U@zT-{8s@6jEcHd9qaPX^qJQjO z1ap@o&^{*;i_b)0YwZYZ_{I6Eklt_GRJhelL!BR~m={HVaj!49bcbs{MFC9a79ib; z@6GW7`h2>`RPHy{=Q&HGab0Ba*iI69qlc`!!?jSF0|<7XNUEud%gb}H(9 zOv3=LbU3OCa6h2{zunKrfGcD{crO)h%g6I@tpxw0m$GV!Vis~r!ke9xh;H$+>ZuA( z|5c&yLr2s*paQI&@#PouolEG}^9{u}?v;CbhoVIpeY46?Jl??beDeeh?3xIxa*k6T zdVHVA++dC${R6WxBq|#nreq_nCK(L!aqY=|wWNPAaK1vlnQVyX8HKtt9aFp8CCISg z1nJ?Vl^Tv(@oJbPvs#kb``ZzdBIvj3>WC?>DxCl12*&{`EO-_Qmu{g@#?kXv6^d4u zLg9Wo6s!9rpnOUKj=g0*0r$bC921{4;A}EE8&N#Z|CEpo|3Nu)#b;v`d6g4WnT@$X zp=E9WP`VHo|D>t2!L?*8OBHG@na2BC`WYim%Hlthm}Gh5wpR7(Rqz8*2w|caW)?jE9otp0wkkTa)Wn0M0R7=29Nx-*CJPS3{Z+-!WSlf!4t zM4e8Kh`9-B#T$jXCtXrW-A&X3Iws2TQu38_Q$L!TB!M$d$@Ad}vizbF#($jPTi+Qa zd~a-5F;A5Kua50QaXKOt9!<#hI1$d!Q|4q)xkN5W}vMRy)-(`rslk6^VmVw)q z^5<+DNj7(qvRkEc<7bsjbXU;xZi;d{6IhN>z`c(j{?z&4+G&5(X+v)<$Llj3hhFm; zzj#K2%-a#nE8{x;WCW%(iNFm@KI>!nj0dIT@3CYVyK!u^PeRRPmo^x#)kNp57N{CeVt zoG@Sf+tm+26aVux`l0Vw^4^#D{pUrXJNFuWIFHq~j>Lkz2o!Ef!<~RM=1j1!@MbDJ zho)f{-N(Pp$isqg_76p~N8lmZZd0;p?gi-c+)=g$sAS0Dtm+Ry;Go zT2p%V8!9mSyaGw@$)1lgVXqm-F;BTA_mDHXSILzZ3Y==i@p-%{2AP@QV_waA{kB;`Igi z^pe*SSb)i;%nP4cfTRyD;uG0X`hV}tYjP2@EzXkFx|4W+F+o1}&Gwf}aDRje>|U85 zb1u2Yi@vxx#E))OALujKOL5y5Z@Cr<3}EeMas--^8Jw+VUU`Q|6zpLJ^@((Bx|fR0 zWKSb_?_?ZFgL}txJetXQ;w7EFKiFs4J0BYt6`-P70W$w)e`2zYtY!xHqI{KnrPk&5z^QV8D4rp?*4vYO!Jf2zDha)g&X#`pY zl82qZJdc&^UEuzAm}5HnbIs$JkcJMA$-_paq4Wat%75}b*;T+ELiU!F6=3^~0yN5OSbIBS*(@ha^>ae^autR)Tm$EaAk|IQbzagr0UPfAS9hg1eJI(qt~uBp&o%I)984UajrqQ;m-fiP zE-Afk}^}tPJ)0n0FHY!0XU+d-8@+2{HjhFT@iE{oH^X}Jjk5jE9 zy&@{CUE+xMZB^Lo6Ux142)1k1;FD)4yf=hmR@YE0dacLP1MH&NfoB}=)V=LFWQ z+4o5hd94-OnpznV>VzrZIiD|7!u_fvs%k4SYY_Kdbwe>QAe85wp{P;7zAle7_`!KB zkK^&Ug9#XPQI8}tmVG%!kJ&`8@9)`|wun7XoX2i{;d*~hHZF7CICfm2#zCI{b6j3A zPoXYvWTKvHZlX4I)5-Um@p7Vp(V@#c z&(1-4tsLC+q)&4K&(6s+jyX+VB**D{oa4_GkwpzjVy`V3)VKuk=+1tQe-p*iBT;M{ zI-)}!9n7b=k9F*s*|3S|X-e0_~w)AR#(__vFdI(s@uTb&# z#C_MmCcL)L9P}y4#`5``*VmH$?4FIWZMbjZyp>6Qu`S;d)ho`Y*A!~kFADWhC%s6| zL@9caDC-gvB|AG&rr4j73FS&0wsmC2gcC+jb0Wj#1p9i9*xNW1gNKBoAd+h^w@~ao z7>YNXSHFHuK8^BV)IJm$SHT2?hk__Ili^5;jC=YQdT}JmctW0ko_KW-%pe~$xK1v*4z`f#ZOWK8?T(^x;W%8Fg6`xc*UUDPC0|RVfPKOD zF42!xYDAAf=E+8xOYd1FqU=DwnA2Cr7)Gn+Z!wjSs-BMc*U7_r>*GjnAvnFn1gD&~M!F9^fEz4X?-r|-w@fA)J&?RS94V~N-7{qmeQpbBPj2y8ju-ab z2}8wFdMXFx(obP7`%jSvWUg`Z9%0xq#ei!`^g<48Bj*~@Ygx^U=WpTI#rJvVe0uR} z(3?5BNLH46B9Z3;F>_hp8^xU8ITq5oCcTy`=_?$mL9Ha_dXuLc5N0Mt_e-Ql8*-gC z;W(X0|Jn`qBj@p4C!$2EC3~=^H4N>9dEW_nNbS{DW|)*o12yw-FNa|+>-CMl=c083 z3z@f?*$M2!@cP6&ZU^#H+qrMOO`l_WrCh&5e_vG?e21ivRby}S5i^kkr7|l6kJ-H3)>dv^4s6vW%OxJ_@#$2dyGCrKXO~O z&7{xupE933@0-`;;K*}r$j(I@V+(mbw^*!n>}iap*Rnwh;?2l2wrMLa=ZeLNu8MYi zUOw((?e%Id&T6fB=2a=1$V>jm1!sIU(gnlci=O$vU5jNs^V8jaqZ5MMq7-~W*}mqo zF}F;{KIeUVJ{;GM8reUX3)74?GR>)6svjmVHi6vkp%i?I;d7)h7cbsd&B8r#lsw?J zKI8${F{hjU%KeAwIVG<*b9ERBd7rCV<>E$7=6X*e-$xH%@&M)(ml(0zoX@+ok!D-V zq*FU@Its&Zva1ogv3a-I&-CS_V5P5j;D(#hS6XnLKJ*A$2x-!m?R73Zuzs zhULP#cS~7Pi@EL0Uw+8@ZTSxaPMGJR%a5k=y;qqu4D!I~1aicmjo3z?MPX7)`Fm=) zOrr1d)JFOfn;S8#VIGohn9H&EWm2P^2fS=FxWk{T)5lzdwdMWUw@f1AJn^fTo?HX# z^P}^zs<6GdA1IU$Px)N9XwcKdh+E#wufNz%+BPVZvss>Sc|u?3^c0*-BcIr*y;#gC zmOPCY>OKua(R^-H|TS%>NP`|?VG=kN4&uCS7$8ai5RJTU7}IQEUE zCwCS3;t(t8$sF@L9oV=96;rL&q zy>(Pu*&DVUsQc8YQ7@W6sSC7yZd&Sw*WKL>3zcc7-ePsZ3Q2&vCqUf|lDZq#c4}CG zeE0mm^}c_6|9-R9tSK~vGbiVqz4x=P=elJl_ZGgBFQ(TlVW=I79|ps=3%Mk6F1t3D z;rRGi*}K{nC+TI&p)c>_MSA@fl7F#{m#%U4_{bdI;+^Du$lpD1H>1+9I9Wu_CG$Wa za{Us~u{Z-ymz3d?DMkk8*de}C5M)Ur*7l)q%TR`-zA@5nu`M%a$a9f5EVIbOf>82G z%i<)gqCG6n1Yy{YL`M$+;BoO~h&LnIHX82HcI2wK4Ya4GSUr znEg*quJOw&X6u&1f=?IkqS4akL@(_30yPH!~COlgeQE zb-#qf+wrx5s2Z7we$z6c@G8TBRnZb+wnu2kK)Cub2lf*AubK+?$K=TJob0f2XfS*d z$O#(B6_O|VMZaFf3#5vd2(`zQH>)sgJ-vtI$o?)dGgmHJ zrjD`4w)6DXDH1U_I1_~j%@{QLuuPyAvW|5iJa|4ol2;nwU5eP~I7uC9k4FJP=*aUK z?3Ic8f6+I0Cq|qX+2eT^a)RaPdFn~-j66{dQ>;XHae$L=09sDbz>S>4w6{TLIm{zoS6J~HExAzB`; zu*JpfAe?6{e==*{M@(k4UVBJB8ggj*K@HjJ_3`e9% z8wbof9srBUe4m{e@HuDZ^DtJNn73QLbQQ+$(vZL6^?#528oAx!wde;-qqni42K}C9 z!tEV%jn5yJIhAZt`Yniki;2h}Kb!p0jK4mT>ntXRyEcS-dE{Q5=pZ1+y5L7N$7DOa ztU&)Jk8^JpxlV60UR{otUZ?0)tjEuV*TeE&?S#kkl&7%!0j)$;nhS%#X!W5x0;c{i&d zytN?*L*CP8hZzZO(P9~557(N3coUk4ts673I+ota({b{L{OKI>n+{i*i#m*X$0=qk z4Nj23o9u9VLJ)8!5$V;K^V^^dQ~2Cio#TMcVFB#zPsGpB8R+9$2Gv`BUgQ}kw^@a@ z;}Y>DjlRM+%qt%dE7R!pTf_ga0k!ELG|~gBs zI#${rbAT=Vq2~h-JT666%gL_ad zekR~pbOuKDGs7d`u#9Wrh}OK1KE)@{UHu4$x|=cM%wgHwn%7SZpEKRa&AHRdx!H^* zk7A{U!WJza1><)!=7F^)pUC&Ael1q!lY8}j8-Vy)NZy`+rlT_Ojk(*0 zuf#~zQafBY$MfmR`~6o2fWvhgZi*cRq(_cm!k5 z2Mu=f^Bq)$JfOr0X4+$W+h9cAN}%hJykQ;s9G&9i;#7M+7Xz`eNg|r|&%}_`sx=RTzsc-)_b3CrC;W; zU4Pl~dXMG_Lkx|tPSiJA_3Gm7k|_PI^f-N5q=VsQtkQ5f@4Y^ER~y6MxAQNqjyb4r zy{?BrQ8>y_$!)T0rq>Sr(0L(l?-!KQuR7I9Khuz}pV{2`VvUir^`rYIx>cF9PH$VU zwf;EkB8OWgG7mIKCQQ-Ez292N4M~vbjz^@;eb#g6Xgu~!E8~Z;AKk2#hX;?4P0`6G z9kT4^4oR|@jIIP}7qnhUnLIwSC?+C;$E@}qgWT}TEh|Twkc6#106f8-PcK0 zV;O7Z#aEdDQC*ED&D40Cug2IFA*}0$u=k0co>T0r>`pHL>qtg#?m_>}zWm2(IKN_V zD)*#QKB+N{H34H4H54D1J=l~^oiXGcr-agxqef0mHLC4q|LQF@R(g<+e5l4Vr%+fd zW36Qj-(#Q}jV5X_BvFgp`5H9Q|L5M}7;>9V#d>sBaGz)5GP+{N=s3S5=eSCX!fP62 z{iZLv0l)sC!7kQB*06q6(o%~tuH5fFNya&pd)U?JF*vD(;tuOv949-o-u0aO5ZNP` zV_la_B>xT6@%Q%DK&|8b_KEM?UW+XD(02H2glVY}wd>P8O`iP9Nh40%nxNXpI#dB2 zIjn6cV!2;EnjGUF^7!0e{?eR#*=yj}B3QU#{pP~btYVrk-B zDvS1;Wh;C8nzS$dUv}-YjU_UP`9JONDlpAcfsy>aTYv%%LG&{2uz)JnET2A>%E$K# ze7{CM($WG?EK6l@7T=c+xy;SXFk)@`XiYkF6c&i|RbX9n<^=_FZ{F1p-i!Ruw$vMy ztNY=_A|K=*WiGDK4?|CSqgJjDru{?j8=0%Om$>iooO_*IyS)0ytlKJn?D_P=>QWzU zYfjh07GFee_Q$_`pYd1y;MHd&8tDAcZHGVVlY3nF$Oq$k`eC%Y55~+G0jsXeaysLS z`074L-NZa6asWLlL}2r=2s~dDfqBCGfWino4Pw@9p9s8Uy`TkaQN`RBA2}xyKXb$J zBP$#uS4UvAdnB&%b#)u_@44@KJ(+w}qez$rkSpM8$B?ZuvbKF^757BwPa648Bv!jJ zuX-zea=*!KJzy4ZN4ghmBT(`$vx+9BVNF3QGOg2auRb$v3(`>AJ{{PS2D?sasNjPKk6+SY?2-n@_v``N z!9D47WFZ5{V0B~G!n0Hayi7yAKFrz8PD73MbUAKH1$L#;mz@Sv{anCsvg2C`tXDja; zhpp7~ZYFmYDrJVEg#;#$vzTuu@4C3iUC&msts}joRTQXN!hQQ0%nuu87T2K)Je#M$ z*ipPs>RZBGM}gI^%H*z1nG8uX%aSn)^xvewxe5xDRW-}Na%HmVCij$*707es`)vFp z#fDOu=0R?e_gwL5=2V|zwzP!>2IVQRbg5Zl+9;5tHjDm*1srQBkZ(~cH>#QC=O@-b z$R3)wPnYo94~Mt=VI=R9CqsPk;jAxCzGPi&sW+ODJ*nmG`#TZ5mIE_qVRUaIG zPY&cXxtSPW+;C!+dw*Z7jP*f-W_}nG#|-x_{s^c&0$&QrM1J(cQnep0{2=pK$sc|N zeo(gbqbJRmpSeHUwerRL>QQhda~QrS0y#?}aFEyexu+3mefqz9hWE(s2wWj2Tu%{+ zT8U&7?~ont%lyj>=1M?30_a%;yq?pH%P-3 z=Tz)ZNu$Fm4U<2R8{&QUAtMbnFQ$<<;-1=%R4gG2@__eT%ok?Hze+{(>Et9`n7ew9 zj#5=FbiAkLAIZfP?;PgN(Zv8n5;zt4K~Kb!9Gc{ODY5PiIO( z4$7tEpdGp5A8*^*;J~o%Z$El%3h5ea}Vupvpt^Cw^{s>*L>Ef3C_aH=VQF z#e)MI8q$ZnbDI%TC4z(kJ{Xy0Gfjsf+R7yBTUdJlB1Su2g@zK`Z@* zsJa(x|uGs z`5YOIwdFK&C6q2kzIJsJoh)dZD92AHN=;+344RW5wr7&$c4C~28l@2}Gp8?HrhC!j zh`4Z``HdM^-v=g$=2?QA8%dvqU6Q!ybmIJ0Cnfxyw>vtbM-_5~tifFNcHlZu2^mdx zk!$efmz8L5PuE461B@d$XRN1W|D+?1PIbcYt&Yg=VTV`M9r1ahBa$mC5qQ%P9y&*6 z=JD%1N4T*6WfotTbb>jSLse+O-kKj}O4tnM*PK6IZb%Bx^*x#~5 zi=pQ<7*LW3mj@b@+|^=cWi7LuHAow+MGohJU8ivG^}7ZYE@{zg8Z+2B>Yy#t;P6fj z^zK>&?Bo7ll9v4wbWELQHd}oy>IZ9Zsu^=NBl$CJO&GGlgbXjv-QF7EP-4VdfBF=c zaNW&)xJqOdOa7sA+m~F@4il>98*!^KSr^t(3@-G2%wc}?6eH3uw;8-@ewgP^KEOBZf-3#O%h7Ba2*4h%CZuw&uT}k(su@_^x zAI8Nni*hVoSEdM9?}&imJDs;4?3b7s3EQrbNKT+rb}_kYKC9lG=QGQV8ODL>m}^f? z?=*V|t}@$x5jnzVy#GJtV*Fr7I!c@*Ylp2YEq0K)+nAME%~_(`TA=kd3zV!P7iVjU zcM)_CJ}ZYw-O1|B^rgeyAJdkRnGf>EdB+jhG?l;KHWE$8(yiA%5>IWT@Sbz28#`h6e=1tasOhGs~86PqRzh~3=_m;WJ7U@{}B^N%Oa&U`$<@~mEIW6P- zryv(C#<|F-qhwEGoFp&1gJjxvl1V+CndxSU#(||W=QsVzF60`GW^wya4!KACFyfvM zc6s|DgY(t9x$MFDn$JU(A2)i_A15g4d0HD_q>^gc8$q|EFlMbnENC= zmXT!~E3eXXRmgnPOU&k+lOo|{+Ditrrr@fTPAih-zntJ92b>T_=4)^#W_CVOqOMAb zI-}Jvlfh`SR*mnKLQ#8SD6BPV42#fWMJ*lHFVN!hEFIR=)S*^o9q#1O`5HjJ;Dr%0 z$fK=4!hQX_%n(jdxPJ>*xa;X3>_aZ326?%ToXyfoH%&6@ z7b-k_>`2Fe5>uL}uzfS@1s}*h)aBa!lp2HL$(55)i8`Rhtz7#5)@bPpNR_hXEzk?i>y;* zfEDv7|4JY)tdaf=Q^auz$G(3ZvGO~|n0n-8PAf5@K!sZEoLCYm=Q{$^G%#>{Ngl0(<0LHx@pIEJ(PGyC@*fo+ zW4_XaiG|E!xI=d4AlLbed2YzdOjxRLzhG_Q-gT9QdzVcL_bbN}$aHJv(dZN@?Uf|| z9z7~klt(4jTZ!mMCF|qN@aX6acsC6dpSyU^7X1#-f|A1j#uH9S%sn{O59kW!WVze9h4lCHwB~o zEj40av-e;d86KXWBjk0?r_)=h*21$;i}k#YcJS*7tsmnkxuyVmwk&R#(2xAgq(kJK zZqm^fpl~lB57PBIxf${*Co5RESG=K=%d^`{xd5efDppF{3T@=XPX`&SvqVTMORlrc zGA>DhJuelw%jfjr^}gt>;Qc<2TsPMyZ+`kCl+Wkz3-s${b3L5PwRNK?JlY?D`@G)+ zL+G!&mX1X)(lBrb`;DyA5&t6{3*Y79_PIPPo|uOyt`VRAlZzwTJe;$1l&xVZSu@s2 zM)hkgo|8Ju3%#>ghyrIV%K=9%;5CFE#JL<>c}(Av{ZOGi-SsU;Ai1eOet%4GN zpTbdr>x{nkkvM*znF%$b=%=M~Z!Q_MLus&%Psd_DtF7Cl?*FSS;rYewsTyWY%R4wyMFZfH!Oz<97B3l zr7tqij~ps9r@4-LINcvlesMk3m$}zXqR=Fo>l#b0aS9`m$FVh`=_Tyu81ZglI?BqW z=i>bFJlr3Zi!M|0(EKv_!7{G%r`wCg zIY)VVuDuv$x=7<~9b`*=XX#vAD%1N|AXY{0GtLqlZd>AHEZ5K6k2hZML+xFDST}@T zL@oRA-uc0X^_r3|5!hWV5*1j>apt%>#gpqqj$Kx3(=oYYI@}%U`V38HLlt{Fo9AKJ zX!<<)xizATdGBKO3*5@XntBe>+t^;xySA4d&K+cauXbW8>nQhPEzqw^IeNa#Qgx0c zb{(_C%_0l*sKL*QYu{Nj{P5Dn54*?vVS6Ea1rA4|71ylmGFa5MsQS1|n#F<6u zcoUP3;~{C-Gc6s<+H$VJYwG19o)LJIW^V|Ba@#({+;vm(H?wWuTwMkk2TeN zvS?)SS0C5Gw+ZiiUoA4%nb=?W7#k*=;QEq#i6_{*Gv0)q298^GE!=mhEZpBPUtWsM zn6}u$-TA3jel1UuAsk1iStrTo@5wUtXOhf+r$Y7xCAObbB6m6cjEkJ$xK7DDpHMu# z5rP~YS^NO@&+~abp3lc)7q#dXNY63HjV>WN%$`l2`Wt)T?-=oUjtN()nXvH(>$$_p z5Ay3VtI1ZLQ@HmhtGAV2y~rKp^XWf+#{HMa4YZ=E#pBXw#jR(OESZ!dtG_$qZJ-io zE4Rh6I2GAmC#;yn@sxG&({0qKd`u0?Cu%5LgyQ@qHTJe8Q#q02Y3(G`nxn;rC@n%m znL!<7!org#6z?&i{V?{gCmNA>pMCD+^Gwz zZbzVx679&rKHQ{2aw8R%_^MESM+mN_ao=NXDBhIPUrAoq$}$x9-)XUrWBj^}TnqNo zVtO+j+!tvvD&jHsVwn$ql%JI&-NMJ%gZ6>7e;;})ds(>u;e4ZL68jeJDcpCgu=u}z z#`&uo%A{$3cZbnVss1PyXRJQD}gQ+}VdK4JCYD zf$Z(#1&`%nIN6_my=vqKCpD7o(SKynXm4~Z4I}%Rim3_Y96jpFwuVLGJ;)QHVm>dq zHdp&>WL2y$6}1I2euNk1k|$byo*dSPY+PcmcU;pyQt7rg=H3fKMN8(r*3QQ5Z}nx$ zi+nM3^F&4${@z~f2Tsez*^~xS$edYKh$me+JF#Lib6Ux1Zf#UYlw%7-G0qb)Kgdh+ z_#4j8#(;N?WZuC-u{gxs>d9f)&f}@@CJWP?>r3lP1yXQ&I9$tzb4^N4%|9F2#f`=9 zYrcGCUh}b!;pjWkz?5yqE*q9V_*6sL%e?P|)}EMOi}lF<%nk3EgH=ncq;7n%M7?E=m3-Ny zs8n(RIoQFR;w6!P#NR|uU*B;2wob*yjX6kP)kr?l8~D)L2SxqEuyY-Ke>ThkpVdlK zx>C8?kQr6vn|e1&MU^($P`+#|8xI!9UuV3KS3*9~U_jL0S(tOFfy^f-c)1sIlOvg< zy}$sQn_1ZV!%8BG@?~g8Z?xh0{I$b?){nDr&7+ZYK2{{T{@#f8A=mlAfXd_(N7ij4 zo#RVI*V_x%FYtKgvd_988`G@Xh~t$asn7i43YEiA%ZfbU66P<>pcijgiNpjCN9Xu( zEVM|azdjpvuGW&0cEvJ;dnzlK8=l^XzRR2}WGLE5rH8*{5zj+~Tj8v?7?6~mjd1RU z9uF^+q;PNi;}(WnuJkJM_)BIrm77`la(uTZtP>-K{wb+m=9|3`Fh2|teN$0H{&Zrw zx)QmvK$`UBeXXS5&?6OJmE>M8)|NfP^X2>iZ{+j}M{~0QI)4AjH2M~Y|B}J4J#p%D z7<@h(aNHvs|MqMkhsV(q>Pb#El-HXo6&dZakwvLkgkx^D=F*B9o1PbIHzMqZcc}?Y%;~yFG-V*`M!|<#w{hr6NVV+!Dreqe&&80rr z5*3c(r3OT_&VtLk`f~YEf!ML{vUX4I2^Q($!28bSNzCd=B_reLDpF_P2I5a*R zW1Ordv-}@9GtGzjN#R&pV8EN=Y#e@QBgP+PQuQ zNv@JS_`_8A?axM!6;@L7^=~nE^gUl3pZ6r-ukrNUEi1$P*3lBz)&WI5f>30g$ee-E+@<(@u z(;qkJu-x5khr0uUaB5m2j%qSk!zqK?%xL*F*A_O*gHW$l0=l(fKF(M2J5}Q44!wBo z5&{v~AOY{cXJGsIGPvA5B#+zLVV*h&iXqGeCKpz+kNLdxl$9~pI3b34!JhOpE@m(I zrZPO(wO=}ur^})T?L@6a){8UgQZl30@@Vnw$Nc3rL2xDyHGtgKKc`F4z$sqrHrZnK zmHi&xo!_{{S;WlAPmTbPmAh#tc_wy0&ILu#xBcVA@SI{C_xD-X)G&UVO) z3&Jt-P`yTyUvo6$?b=wmk!OpByw)nudoZVGP|B zJU=OXeVw2T+?!{H`JcnmhU@Co{j<;L8hgdE`B#Z;`jXT85VcW8@RPhp)Z`Aael!zsiwSX>UgM;sa7R!~tcF zfrwM`ym=bo>{^B;nge1>f8yk0!Dx3h5$`Oy_wl(5KbS*pqOY)ue;{tPVa?B!ff3{! z+j9-({SvQT(z4r&?PEA|gLfvMzV&vlCx2P@_^PYK4H zd5L&=H3LU@{S@7c7Vo;`J-IfW+?$@kn;95$y$l{Z;>6m<9yjToT*mX0xskji`McX^ zqh&as8^b0B(w?j#3bV)h8WGaQjJdnx zBxtN14)o@AHHO|&zYMHzYsS>{Xla^ahoF5SSUWTk>qcgxOF$VO-ij8{*`xUhX4sIY zsvnqvCw^tHR>nw`2LCVrZq4)H6+*x2cRq*5#z=#Q_E>u}5H-Ct$X-VuZdY=ttKwzX zO$SU|AB0yY60zxW1}@n%-)CW*++R*_%Yy(kcG95H(Mk{g3tOtKInsuJ20!w;$%BP$=T}UTJZ(jtKwwzkmL}U;lr< z|KHF2=LYdf7<}RJh7A4C28nu?fM@!u%^SF`UeZ7xdGxnFEp&MrZ*~QJncJy$_a5enB^142+U5ftpkgFG4e;#l# z$+3-FSu;Dg&8D!6A7-`FpV;}kN9yo1J#Ob;yEsQ>cd>`NjsEcFCHfmD*6Kf8@YO%P zfB9nVR~l*Fjqb!n8oACrWz`>zRAbgg--jZ`t>_KT&#I&`KyX6#n|5 zk)QsFVz6VsdM=$icN63(^PHLtraxyJ_b&P}Ln%im6{8cRULBom|E!atAGK1rOhYFM z*U}Ej@@89{Y-HYGyMgSXyv23CE!Lma8zDHTuM5N-Sq@zh?_2_CK|Q(-8-FZB$~9H?yZ|(BIhGk#1cj)E1#AdeXdsAjI08UZ)CAI&=U zoNjb0@@FHs|9!P$_o^|=TCo~)e$(-DCIkanlRw^q z8A@--LE5O%pf|IVxIfTvjRuL$wVY#f&mfZf&K+2zchkb3?DJpi=*?mMKJ+)Ur?}^w zpU6KS&|q~k^D~^ZDEP_zr{`Lv?&7`!T{?^3()s8|HnFZ2+f8H^`|9xiTO!6S=4&jq zn6q1h<=$F!jHBb=o(B2c*G`CM_62`F-eiRTaU<$=V!h{!5jDmeG1c=iirtO49B)J+ z>vcJ`+2_mWa?S=LwCuAzmcgD2*6d$QVf~{5dz6cf2x1*=2VZ}oG!svQjj%WH>xcCD zOy&M`O?ofFS>tywq3Lnf_?yzllf@d~HzTs!nK1vf34NC_0xSMD%iO^V)bCg<2W`vb zf!YFnR0>S)XO_(`6u9hffm@wf<{--{zxm~dtKw&x~(5pobW;Y{(jhchTg`l^g|BxB`e{J zZcCY|`-;3&7&E7jFrW5V6mHy)z%w1!`!10PxJRerzu_pyn)E{Mv$V*Gz>5g-R^+M1 zkss)Pii}m=DEO2ozqlY0lm3asqAkpouEqUW{@wi-5$L)(0&^QO-_VV2IX~uACq*Ee z`^B~fW(-#1*O3uez`9to8j2h9s1uErLhMq4UfrPE#}_ywwnC@`!pQ9%l@&^tbO%P!-A1% zSZ7W{gVAZo=u1v=3*Xm7zJMI$HnNUOwx%P1zi-4q*8Q7sKVnHbx(?38qyxFASwENg z>U74<$VCY2bQ_~`(RDAgr!#Z$;Rk(iabzRf=AzbD=1DckMN9VNE-21HR=+&#&ZAq1 z%;VTS^fCJ80x@|QSIX?$TDfREA`gR8n4xP&&ha~cS3EN(9P*H~joA%8%r)$g$MeqI z-SfF9&d!Bv7p2^Ebdc=lEoGG2Q9gS)%GtWD<@!rUY59*zdNgp5WG{Q^H_=|k|7$B# zD>#W?D`zFa95_v%uSS(~;B+=;iu_KBrZeqWg+ zy)Tn%+x+oQtRFtuli|%|E|-lzCLZ@CALWY*9zJ+;gr1bMe%R#8%=UG@$T~=0<0L;6 z@g8c%`=x4aAFMpZER;ijXwlgh5vhK>2mF`|;g2<7p663vRC1y>^{p>64|pH-^+6Y% zKl5bych#6Zy2l3}+WW)G&ktq1KevQMqO=Y3Bgq^F^e1P-n!yVl8RDw+SX3t4Q7IBF z^TJ`%i4LZB5%^g}?@n;>^G|4t+#W^vD~1@p~1&>yuh0%o!fhko(CdcA6=6@nkJtzX&2jQ5&pQ&K9R;m@U^TN7rw2c;sqe;TI#NX6lw^gd2bC##T-4fp6z(J&XD_ng@- z9i_)oVNPaGDetisM{{v3qFgW4anO+`Hp@ zC9mQ=7o3Y(3vzMkI{7Bva|x^RFuUi?i`80p(I2Wt48}EGU#C}?zVhrkh7Z%1UT9w| zJ@#f*GF+`TuE&*uUT$lKbTq846n(K{(UKl*QY#v2sM_d172k9_KBv?zvD#hz%2hk{ zTd&`|FsC58hi}gI9*^@P^n-Wr(|5SH|6*motcxx;OWdYTd*b%COsW6U@7jflE$bQ@ zc~moWm!WRWn{U=HZ=*Eas+uCYjq$R=I#E7lB+Ay=NpfROl9V?j%E_5pIrp93#q7S{Uzlzu!vn5$R_18%1NS!>Ws1tW)ZcYkI zkaQod)NQPhG1chk-mZ}YNeObtm-!FOrgoe_M$)8_c=pR|7^jiA2i%(?UlBT7g)(2I8%x4Ax^O3_mfQy99tcc`I`(R=afrR z9WgLdiGTl6qCqmf-Xm0a|CCv6-=f8?W&}U-^E^tmbo=%b>E}?klqQ=O(tXXir*Y6}f zQqJTZZiZm!cQsUgYWNJK3u6znr^D3f>q}1YF8}*26w`Wg&iI)eBVFD02Sedef%Czx zOoi57p6L#(1DZ!(>pFYa%eIJc|Bz0QO;TJ~bo<(5{ zLVCRC`n9$eO>{c!K1*MSk^cQ>iI`u=_1^^zCUDMp@wyhLJhe!_ZA3BmN9zO_aksY# z6W-CMm`w(edvSfw8u9uF-Q07H%p{<9n``}`d?O0#8gb8-Zbj~6Rv5)SRpzSQ-e$xb zGLU1Nk@q-igxQ6Ack_%`xP5p;kU(P#IIF}4G z;WWSgKYm8{*7PL3c9HsvouwIhhcVmROHcN|#ND!hnbg~XL{oq>UhZ}Fm>G8Q<#`(`b3nGv} zUd4YVdA(R>h2A9>H#Qvy$T{G7Iz3y=q$FQ3HkR{?{mfBrz#K^DFF2FVylMKaaI3W> zcC?cWR|m1QR7&+DO6kmVF|%GdbXaH!H%&Q=sHH$pIwSqg^LKN8XFu7W`{DjLm*b1Q zP5fZ}jBI=k^S2G*XvHz6wqqp5{fWd9KD!Inr^99(`#N5yq3(%GIP-$M0p~Tgc6sQO zl#4G7zu>$DeOLW*(YLcomRWX`bNco&(z>(!ZqQD;RPP{T_R`&S#uC>TlR3StfO}jy z1o1P>twTrT79Nk8{WcBB`_oT0vYRia4~c@q=_sVmqI;0@#)(Drf>$SVsZGWC8R@8z zNIyUV8H}#!h^$S_?oZ&^LW&M;jUMjzuwT-yvY)nM+exD5op=aA4B*0VMh*~WDR`rZ5ugDj;DJoMWJam z@`InrdKQp9-4KZb>GYu$@-zF9MmIn6UWcb6#qtt1JCm0WCvQrZR9?R?sGg9E-%Gz> z$8Z-}-?_cqOJ^pyvz^?o(?N`XJ2P9vl6eM}SU$;;S@LG-!hVmv{VieIIs)+r$%BBs zN}S)%cK_@?dlkSx!;7H}z7u59&nM-W`SeH0CKE*p?u(=oNlgQ7fOb z5+#!3RWEw3;wz{yV6qb~vo^5HN`;gqtPkWnVo4!6#&K%29M3)dL*(OTsu4IM6odGD zTuh5Hn; zjlnxvbBbj@u0BO(wMvrX*7P^MV=re?vaJ4*B6rE9?8{f7z?E#}da@xul(0-tp~tmQ z1XNqi-exsw^-?3-i5|kfJe~ns_=RZ^ypJB1&(eff$l=);F$T<}7yeuL|=$}j9-@Rl>8qUm6W^L4TN|wV5lO$o*QAy~c!oufH zz#1pa?L*FiUq}8@VR5n=?W=^MOQTTkgR;gkS&cM~YvVaa+z8fU>mLoyd}YQe8H@@? zS)fA%yEAUOz|KKfvSJ zJU|D#D>_W>qr=B(bfxVlPqdVLW8cT{wlksZ0~z@fk2&T)M&k0v$oubH)U$A(N*3hZ zS>~F?lOsG##__98{<(Hsnv>i4;jEK{{3O{KeUx4!6+Ro-2kWQAiO-ya3{oM;h3BVJ zD6Uo}2TKNapHYpC9K)-8QDXx?r-*g*Gv<;{xvF7ZihQhv4l8**dy5f|>zVMI+^64r zo~H>$_TMnSv`pdN;+MkxQxyyMtGg`RT~?D3ncyT%3!4eU)}_+;4iY@Mvjp(Zm&PdY z*=UJI6%^?3tW-uHDV4Dv7RY-t0w=Gs*KoN%x;OS`pAy}!<-v_IMvY) zK{I@Ct0H-7-zc==aqL`ArZJyAQ%mR|w2DG#ch2?uUBasfK6i$(@2O8ZOgrgnyv6nI zw;c37L3dFQ$JG_&<@D^~JEr8^l3wB7oh0>uQofJq$c#@H=}V@2{W1#->&!8Ax+PX^ zwtzmx0*74uaqJU&%A%Ob&9T1!NFLMX|HgdsajzobcR2#~C&Teq>quyH`3 zz1@j))uyDQ!tQjmT9JlXGuaPyJ{P{H^Du(z24}9_$Gy+PfjRAD`J>LVqI`RCWgV(! zlMYhphLe0Nv_Qnja`-TqPUvcUR=Zf@%u);7IOm7nb^Q>W?~8X&*b5rxi-{}zvFhJQ z^!-EMJ;(R&!z1BoABk#Nk>muJ!~HfD?{w)n6L$%RGwIiKWB#-Ue|J~*EZC5*teb}~ zTj-kqn1}DDT;zhUgM8ZHA`$28<=^{ubP=_c=-!s78exflmX?W*Ec~{oJXcqlLA}@) zJumZ|Oz^{e_Nnff$2II7e<(TMaA+Qd@|ICJaUlu^J~HcqYr};{(x4{;>z$pBa{PC| z>vVi&KKR9NdAMCE4>P;vL3JY!A2_BSXp)DcUtHzq)vnS;<08Z8%)ZvQGkYJM+lO;+ASu)$o5+j30U|RuFQKIuXC)gy@gGdg|rJfRlwyW6t9SR#h4+kZL;)|Xh zyNl%Y`26{LNrTGQIA+zqb2BuyBue zv~V94p>Y41NskSmg)=#pNqUM@+Mc)M`XaV6tSqRlj-M`c>h%e+g3`{2YUlj zxi)&G#Pss3ak5m6!)?hjZe_1P5_{vftMNDI{#I+~U2mhqRX5gm?X|4oks-Wd#FVin zJgfH@Kc~{|TjL46j&uz3S=gQXBposo?iN$Y;X7HluXVO?-|{O-#@y1#PWPi?`6*dW zFVadzL!De_esS{@XZ+?f@Zn-54qjGbt%ag9=*>z&2_^=fg9pTR!* zv0A(vuEp$R_SoyRII@g2=XNHv8E3+-2JA;75-rt;5>;T8v+>!$xZzre7t`$nky>*Dbn0BaU1D=Za_FMD53T z_TEVEmBPJcbNU7wS-8huRk+_G1K*^Zg}dfOqQu-wktKiVVV;*LzdP#0snsz_AL4|0 zwN=O)r^3WLTtn7%M$UC5a(<|hurw6y--lq5Qz&Z^YRnz|-+E7ndQ(}a=Q*l%TML)@ z{OpG7aK=d1bJSzh=X&UY?-P{DW1O$Waf8P(*3-hh&vH6F*{{%z=P7QE!aZy0F>&xu zk<;apWdPmF$L6y~@LRI@XjK^ZTZMN+x!xVCL~)W66gO0uo2F*}SSVcUgrdgnP>idl z#-tdIu>tH~`^hyQ+1xezxDP=`WA`8}`p1~?Ws(V-uCYJO?lEexcE5YbW4Qiz{nWN_ zKS{>&1dnGmujer4h5w&**uN>w<*!2pVn1g%>zVYRsZ(*g7P+nI)^e*6xg-~IRUgBk z%cQ4F$=+-4`qHn?PpK9@4DAPm zd?T4Twpa=p3`hFRaEu>mz|Ak&khM)EyB>Xu#q8y8!9KV(sVEF#9<&8>u|E}xCfyq~ zJekMZj`<_+v(fFol?-L>^Y40IsB<$6eFDh4k&E2%t(8Q5FOp-EhGXB>Fr?KZcbS)s zO@B9%6NW-5EE&{0ue66zF6;A*~qdvaS-QpsIs!+AhcQ4KDZkG3LDx9pyvAQ*r_dW8Z>yF{f5ZH;pV+J(pNk3-gCi0=QNZj9& zr)$T3huQ`#=I7FJWPKTOyF^Ztdwtm?9G|`#kn<%AwZ>UXOXeEe4Ddw?`OWb!4RGLj zuIy+pwcF>*+bB=;aSlUulK~msv$67IBk^Fq?a6YU=szS369=Xtyh;uQ#&6jX zOE2E)aEv9lHDFjauJ36fxKt=V?Yz*F*I{FRj+1yi>z7%}(>mn5%*-QZj`K@va%Y># zk#%S!!SsYy>gWSK_e#p`(_?o`7Ai2W*=}=@Pu^6fC@2c;stCHdBE4P{G4p|r>z zj(~nU(YSmnt{HRCrL2yOr_Z!isTU?6*@>G!=;d6`T;MM)rCDaaT=Aec^AWv`7Y*>g zn+^XhO{MTcf!z7m3l4GNa6V^XO*$KEbDPLpk9@h^$_KB1@;vI(zHVqLt+o}5U5qEH@i@;1rlNf><`kc6EKQsWrTtAW)MXuIN^@rM z(900psG&6ZQ!J68p0Hs3`1YbySj5w_nb%M{IhILsS08-i^*ri3pAQenOXf6|dyjsL zRdf1DJ;E_S=#Jo=%)!@Mg4X?!ZN0qU{grv>O7g|mvXR@xUV2y;$i1@R^jU}DuuUp% zYP0BbZY(XY7s=UnURbK-=e0?Xi7&ITfjPy&UH-_HRi0?_kk@mn0j1yuN(c02eT15sg^Wz zD3*X*p7=3<-hyogWX;Y(Zo4|tdRl>eF7igylW-g)|9jIt8`>|{GGNXhdA`dV19|^8 zqu26q3v!e_n~1mSk1U)%9K*B2V0>?Y_t9+ZbZsbw?+e5+dKl`A3WHTdDmwS0XLCg} znYyb`O7_#+=*|6t3e4$#n~h(c8cS-OBI&f4|6gTc7+O0O{#Ja>RI4YJ)`gPt$`_~J zhojyTa)RUmcXF?^#JflujPpX}Zea-JUfF2B98_|wFRyZoWCMBdasfNxFd-E+{>s7P zO7&z_UV-fQ9*%9~Pmid{P4}UHb6`F3qZe}bm|@t*>-Kdm-tXjRtDLPbb67Zk_s0v? z?{{KYq5;9_*%^99z!)1da=JW?0M34f)c6&rjzW^k!byW0_Aj z;zqU-OOFCM|IG^r$%79GVGdN=9Ncz}m5$_M+$>kYbR`jyu9=A6Xhw^_4@$*$wj3wv zFQdoseF5v6HOMFSjFIX49PnaW5Z2byVBR14-QJa9$If`k^RQ(WkQ%>|>1V7-Z`xyW zOo{YuwYJCjhe7D!L&wll@@4jB{Cs{;f^+N<8OyAny$J~B_ZJT#2iGlLzE0-x&luR^zMP6yhAxS!KkIqJV1}`UKa%cvir9Uw(M!LclA0-4P8}c>p z>19hZ<3jy-xzD`jYR>|>eoDkwzW>DUX1vLdmjm-{@&Ax^7G6>3Vf&uJT6gUh!6pYp z6kGJU$68w&ySqE6!R`VE1C|6sF>@LDw3qWw@_Tlo{ki4z~?M;EN=r^7TvqErVX-rJ0{2Dl!MTl zV`bVKdu&-vF3&)(nU-s~MhbOOw|!Fols!iKEkom9^d$DnLD+9{m;C##Bo8>c6M3i@ z9loB*M&8{rRM5mqt()ZalIXdsOg_Rc8wpm->28uBzkk_dxmO6LO{aftZ#MSUSE&2G zKPUy(_ITAf2=z0QpeAqVS6!hVKwshY(e^M8T!vHR>Ds+zAAeVR-y##`T$UX&9xub+ zV|0jFpN%(8WoXtpUebN+G3$OXd3YVF9VO5BnEuW7^ccQyU|lPWxet28yvc^um@+I$ z+AoJzIbjF6lJgt%n6f+@k;*bewoZ`igPc%ZyA1vEnX9{!{zqP)=Jn&G^xu}a!@Tcy z8<;D-IR|pI4DPk!Oz9L%_Fsp7OR|v^WkJmBJ(5<~0&i=DVEb#<0qk?Qr}~Y$ z^jGfc?|`sqa-d6eaM+py|I=mI`XoV~k+?i1g~4@5qvraCu&>Zu{lu&`8c4#j$oX=O}}9a=8Q&@ zGyNGWarO>~KgQ36_d}~2&Hp>UXX*Kf6{BY zV84{su*ces!I*tI2{St6U}ih!iPw&kzNPl?_6b4lx6Gs0-$l8RkL|N{=M3|BgcmvX~s`G4gt2PBRDDHV2pa`Sx*5kiKxhGiHr#`Kg25@*J#P$1}vE z2@<-_30KAkV_9>4AIE3o_Db@Yar7sSvBv`I5KIZwVcRb9cS#)gw#G>e`QN<$p*XgW z_gi23WXI6&nZf*S^004rg&?+wyrc&`mE`Y!(T|zG$euYr^laYJF$;_wcSae;rYA^g zO()!*K#rR}%AMKt&-z*Lcvyn8IOKqy{{$nl4*Afh*|?$M_px8RyxD7q;UPnF~+v=Pu?)PZ|@9+I;?KO*R_yI$S)qU#3LRBY7$WHA{J)JR%3}P=?$gd!l7~`Tb&T73c;U6N%-xa%B+cdp&Hf`N9&!jn$?%cXd z#xQ0lN;i2fs#7&R$W(B;MeRR4O_gV)CGUy! z)W+UVoAfO(J@cPGGrUjVKU1!Ut*1Qhnbvbby^NCMjnkJlYLhW3r9;L)4%IUj{%Fw6 zII%%S3)#?hSHCOijoBSf{O{_n*r8ToSQkF`l{0pCVzzWY7mVwv!kHwxcDk~*{lXd5J2}xY?t%fAnEx=H zeB=s8yoz>4hq25tEOy4p&0+X(nzsS%E->O4Q0qrvOj8bqcsTe>-YK1((DJ~bT6gEZ*7 zITU)<#*fTo4X2?7k9+eh{&E;Sw9KB^5sF(n4fI1a%sFHJL~YipYa5~IM*s0+J+85~ z9J7!4e(c*E&d2@wu?LsuRSowu7kU}_#kB^!U&RcKd3wy@xzU`PdQ5mj2H2VX059l( z{)_#(>`C1)lQoDz?2&E9dQG^V{Ffg4HX6~1^I)=x=k9d)yy5E~=6O$bvchWy^S!WU zvj1uxE|#Y&qaO31hv#C`G&A(9Rkw9ElgFb==QSC}?L6m5w(OMn@t z{-%R*Yc2{)bFsd&8I9iNB8UHds)!DUES?{o$icQu=1MDa;jg3Dhwh#1Xu60`neljH zE;ie+R{k$tKWACX;+nA$&-o8sY9;gTxJq(&l^odQCTV@i9eTUVOIKI1@8v8vqEu4p zva57>-bR$Qon=UpqclrzCij{;N+tG%H+|tQ*=ro6`m+|&a47Q|_?$k>kshyaB^?#6 zlEkb#yDrV-gV9dXA300A(QXnq-bG#qIf-wsi!8LXkc*32Nl5dSa{e~YU~4Mq-?K=w zNCiH_y#&f=Kn(U8DPw69YBA=M!gB&HDioX7+w$Tr*9{EB& zCIE5s{V^tRhpJPqFR)m;`x>#3jOQybq0_%aMYsGQ!-c8wNQT4qH$YhTR)CO*TYdzZf6a7 zJUvFuv(RHVxkc99qxaJ_;AVpTdh%4Gv*5>C#Vw6 z9N&_OH8;p7`t!f5)2p-4ghMTv^SG28SCR=&K4jw0H<>8&&&1~<`WV-;Hqtr^4>cyl z@^vqgeenC03F~hrOgdDEORbCGF{2RUbLiw*Uxf6Yto0`sVakC*6nPXP=QjV%x_|tp zLX25jg#GJ^@Ng`%5xAgR6Mc?5S)Yz8#P^eY&QE%zYSKwJ$xf8Rn@gR8Z6uHx(bK*;O58nn zxgXL>(p9ZwL{%3#Q>~>0@O!ZMLo3;HjIN-Q&1F05CW8k#iBo@Ok>#`zYezaEKDCl< z9~(=ZSe4{FQpudYtz-zZ;aAVJ<@e4(c4axs0l3PAJMPk=eKS!STS;DugY-M(C|9Q2 zlY_UDj#12RXO`j`I|VAQP~sSCRJRW+(9>IqRc;C_^(m8m-T3_)O&{uKdK?E?WboTE zxs|L$n+FO+t)ye>x)MpR6i9AZCMz5M7Arsc8^0@f#!1K0ae7eam5C#n<8>o`%UWyZ zrZp&&F$W|Jd$OK>V z#hX2>*|_>+&s$&ok?VsM<9w0Pi1jySxsR>jM^45Mmc_m}3qOtp{-|@&A78d>nI#kj zZKxKV&yd$8@4NMnDEvXrrB5d`gCyUZ{p9zm_+2cKheB&B^4=-dO?3M{V zv+3h_$uqMRtjk*QyLa7$>oIhb71QT9&jg2B?@?BPd2o^BRMr;YXc03l?vd*?7vd4W zI}%Coy$j7jr zd4v8eGQ}VI(67oftlF%ZZSW=+(}Nr`pS$Q{0sd%Gh(p^75i-3HA4%`kuTT2NX`MXXZj4F~Ze0G% zy{I4QKY!FuKT+4@`S#QPv~#)LGul*-Pv1PxJ-x>VH$MH+ntB;M zG*8lWWo2nIVs>^7ja}tgf1^3ASzza`4Hu-R%?a3>t{zlBGsGV170V~TF+Ez(aRt~)f2_(GW%V28s+rMWQm=g zBIUm8MeUa?hl1m!+p9#`O#r545TMeA2(4noS zi|IPoiaG34IYl>9P#A(;>F>5^P>JU~^@BAS$j8+WSkv>+;CzY(5xyF18_ilD|J(y( z7^ZpC?|p;$lze=%V;J;v=mb}3FeRLSW{C#a#x*DFU9(yD>c!rd^mn0%;kwb7WI)5= z20Flva37<`KfPHSByUriLMG9}02AGbed7(N%XQ=uHS3udm|<4Mh((jgov?oQZoQuF zSOXU4F`t?YQ7@j+=@%RD(8_=MJ8`oz_M0})pi!C`qK)l3)q`+%NJ#L>9(Fb6fPM7SVa~?*FlSRN28FoCmP#V zkR4||{VaKhU2@!76Ta}*Rrf3;#L$fx%Q5!PBFvpx zglUWE{flJ&)#pNlbA0R9+Ere5RY_D!dr?_bvhIZJnft};_OuuL{C zw1N+v$9w-CiqMbb>^BC$Ei?e-y!3k4hH)@FXMixd20EGNVghi1M?^h&vadae|BZ&1x;}t=;7012;); z>n0uQxJ#iZ(f*P}EFTqUmi}8}+!dI5murD^=7v`CL*Z4fXUXrhS;L-yL%t}C=5@&@ z-(VMwYc;ee?x@ACN96E3(D(H<3;nl{ci3!V-b5B!k}3T9qW}%Ja-7eggUrPDMg}8) zbrGs`bd$#RZRIa5*EJ>XQX#XAB(H5HFZi>2%~8PXDZQTKmDuB44pyQ-!>i0z?dFdr zpM0^kM<8o@WQmG>QBo}mmAS?p+mAWZoL}$y&=(o0MXfj!{JH+y*UE$r%gN#wWHBd_ z@25u*Z1ak+@J%6hkWX33dCO)mdrr!Ckg43aL>y@+3a{2OYEf&M)!aemS*$Sni4_hH zw1~@0CB{s&;vCF=s0qH9Rx1!oSNY@Us6f;?$lfBZ<7--xeWhn+<)7?*$kXE84J|&l zB5OJN97c_#ugy6NOJU;mrE_aH=TvuoJ{QTs+83egcdk?S7om}*05932sN86j4rlbz zps7*rc^Re62!rIl;g~#$+{Ivy-wrPLyMrqhZ*oO$C%O;!YG7VTR_~eyH*PTtVO%(J zZs@V%8Chzrk$E`G>YQwV`#1yax{!yfWk%8ix?hj5&yB9VmF4p=;{{p0L^6#j^fGD` z>h%klUEEZuzW1*|emqW=f5_EeT$ds#j}0>Syiw+>UGX<-`cI=&aIkU0^uexhGxI#* zY&c%;ryt2c7vfd&abDr@-WHDI)&{&i$~**Lx^GX=Jy@3<#%nSdwR0h@@({fwmuu`? zytrwGe-htgyh6Q^4B>I|db5@&)Tvv@V-(O+6p<|1t8`MxZ0Erhlck7#1HFf*h+{=p zsLAJtG*e+J*}-`RC!~>W{84#12F+z|aeXo%tHO}%%Ih;qgVr3ozgZjcme*zZSOcmp zW_IymBX-5HXE2%L;cPPwH0FMMEnTyuSU0eC7T;{28K9e@j)U z*O46@{ga;+^PUHh3>jW+LI%!Zj|cLDr_W6v}>LUaaOHx*qgnn z*3K|i)nLJ=FgW}syVEKh3pt1O{>J{$FU-ZPWWc$<$)WyZz@=M8^vE5KdQH7^a45FjgH7!&428CuwkUHnYLI^7HaA zqVYS6Cx^eCb0g=;0INJW%*@5$2h1?-qfi&}J&Yc&RD1PNs=qEG z+xWsklJ2=k*)tEh@PYfMbI!7NLMyqsNrBBvEwX5*57W8+bYpiLw@j_ANEZ1$9|qCWR%fWOBVi0RWgjxT6`X=g}l?EgyT`HP795T z3CB2JG;pmw#x1V4uz2XLX6x8e z4kq(i%=h&#-GkQ@SWV7+)KLXij{YSclgPgp(Gz*p2g&p=zpUhs=6iUy!S{ANBMP3} zBVFbBgKxMNy~;;pPHr^b-!|diMY4<|xz}jH-o*&=@8#*wy-wz1P$7DBDuUh4LUjIG zh#OVt^YwO;xB0E)LLZ(xy>OD4*>3Wl4$FU|c_wt8`^(DZFmSdK+8YYo%2S{R=ZHz( z{?Kauaqhb>>L8vAJUxy^g0J@Q-w|QRjR}Al?ZdnNF$8(T(?2WW4!tq4rV3UI#bEgPS;T;H zW6sDC`XaeE4LuNzFM2IrHPXUoC42RF&qU0~f&;J3kv>_7=UL7*NA4$wa6a$L^$xjw zciZ={_GiXLGp;)d^wM~cUb+rTmb|!R`9*hpHob_idA95^!3oO0nB&9m`H}UmxW=>N zmy0#XGlXLS$7i?E%;;4v$0^oWU+mGN{Cv(6K}PgDX22)1gkvJ<`#Wj=AEt577c=Hv zx6SQh6Br1F|?4W+uy? zb}qPAM}>A87qnl^^KM7-gPcFwP6(${T!T6nG}wMfgNYo2diLU3Gv|qedF1c8-fvJq zzxrGw3fj^!%=6gme&ngAu!o4_P6zgeFYA_v;#&&!xMYQTWqqaEhg|+hqe8ubu11@7 z$@0B{PPXZjW)a3v&?hapXG*!jp-d6<%B*}R4`v;A6Y7Wx-XeY6v(|z2;IvE z*pqcugXI&$nbBfI%Zqfov&KH&$%wtqMue6#qQNaCFqb**FM;5i;fFExmB9fOQzJwx})AeCCDN~aLcV>eaU{*)O{+%tyd zIb*q-6D~hyFWmVsCUVZ`Vnppk?u)pW z7`4TW)qTwPS<#FuOY?BJh-cXc73wQ=FSq-uP-l?E|G^%Cf5?08;J&!7q{^EEsWSDr zLF#`uicxKpL@PID1*;HRk8`^}dj+n#;M59dxPGFqz#N8sye>bggroI5UaJ5)`@7RG zFp{5FeKPs83~0mmc8q&Cs}M6n+2=LcHxHYV+0$=x4H+ z)H~>n9MG74>Y7L7-ySJ4gKp{<_YAVEhd~^UvX^9|3QM@pjph4VGR76j)5z$u_Aqx0 z9gS_nQEnYwqo=w5e8#=*O1d-;v0rTu``+&JTAkIS;spa1@n>g7(f`~f5BFcvt!c-- z+h?wU4znMC>z%50N;P=zRQbivj;!wg@{Biz)Rp4mVwu?A2WzH9Ag?=fPRS*yTpCN= zy+7o{8gCpw5s3nFI*J9%r7hn`@@oH(!v=4j{YT>bbu!#j^6`WDzb~`C%TYb^l7)JmWg%$;LF1 z{gaAi@IY^z7+WxhbVtOj)wfDwN@^MRV@;dwFqsg5H zvU6;)DDHcq6FJR7zR#VR%u)TPg|u}0DZ^X%AZ-Bm15ugqAdFG<$!_$QW-VHHk#&AbS1CCHXuh zcX_)+p3R}>@o@xd&CNtgy#n;EXCumz5}8}k8<9agdpwzeitF=%#x^pf_Ybk$@!?qt zy_}{D4CREKiF>Crbuy{gV%+Rb$ZxluAk!Z^ZaT!lPU!%*Ws1&TAVvki(xl$qQr2 z!`i;)&%N^wP50Q!qFKLWUa1deB}Jl`??31=dBZR}c}TzB^jkiNJIP#v!{lnoqbY`4 zOYG;b61UbHZKg#c_*f=xHY`A$qc-xHYY@j;zG#yi37@ibJgdy!>Ke8(bxf%YXa4fv zDH0Yz-?}%IOWEIL>R9GhFNws)D)d@bEI{=Q4J0+V z;KlI>e2UG$$f^bSGQn9MG8cFYbAE%gk#N1APLF>+(qSWGTNg{8j3H!0BN3v_K+~W3 zIDVk69J%&Qip<_*W&>5Z!7<_?jI9Q)}V&i=5GTR-TF z%wkTuE&`b$B8RO@2#7g%A7Bn16jd1DoEy!;1X+V!f6Z^-rmv>Wz2gVe`pB z-#d|y)1i$daNZ9Y_Ft|vum6~s4D{i+^z~?Cd3A>O=Yb)pus;%caT)k=;w`ogu$B2P zKV?I6Z#49afP1%0wEV=p_;(HIY5gVloqXs$jfC&AOf-sPX3+KqvcB&! zUw?Z_J{&f;l(_rFlK;{NgA*dLnH;MPYe*j_w-oI=j!TWn4;Dp`P2xHHD2|_2Hc~CN zL}q^D`;3U-oRxtW!}BqEwvE(nUM9oIGnQ3hU7~{t?b|XV%-2D_{>Lvr_lC(7iJUf> z*jlRq;R_l_kT?0$aPr7k$v^JT#4O%#-!|8hUX{Lz>W~j=b3AEOmVqx1^HIB+wWRPq z={bq>MOp-Q-(s$PdAbHBG?i*COC*NA(X>~QIIQB|_dETtXeo-sA9C@X4-~x52h7bt zr3~Jms+Q86j+k$Y$zA3~U@pf2W1j*z7bVCc=9$*W4u*OgeQJMYv)_lgx?Sisb8*De zJ;7+QREJw`wsh zEb!c#AcN_5J2aJkuA$^#_UE8hj6$vKx?g7bJ7C#1`Vi?29CtSd-Ye*Xi%F1Cp)GM} z^fEl@s>7?}IdEuJhFJ?^rF}TPW_BS+U(dX0U*?~VWPeKHehHZ6h)>x;STse4CE@f8 zRg>9JMgC`^mOAp!%5*bgQI8C7$P`9i(q@<6b#9#{m<`F-_rGzLXrF?phfJlN&1AN1tZL zAo%{FNBei#PzPFYa$}MVGuffSh!8YUk}I5_jgD?*nEd{LZ1%9n@S!1yNY=slF&jNx z6zcIO_e%xxiD$2p{pg~{Xn*DxIWbqdFhL%5cR+AN7)sxe<0Efqe9QN*PLM144rJ;> zu)&;!;R|!{p6_$i-gtTEX%G7}=5CX7T-`1Q`)e!Ifo_QsSY`+9giv~Sm{aVZgK^8s z&~`f68}4JqnL_buwjP7Wt z;Kc{z<3b1Y_X&bpOTS@M4g#8Tk5M~GY{og^@cB^8IzmrhbNT`Ed7b<2lPBvOu?@`a zO;19#V>~B$UxvD!m?!?3dDir4E*`?yX~X-3Je{E=PEL6`V%&}pblJ@J$(n+?J@4ld zdJ^B+WBct8I4N~dUC&091`74i6rBtlWsiQNgYoYt=5(iLw z@8t7c$rmrQps!bTCgS{ zLAEz?f|nu$Z$gsbv6Mc_Ze(dKa!-B;*`{XhCyCbWDq5qx)`#QN;K7m{wy@&gATjJj(%V1A0>g^xd=xj%CpkJKK zuIa?Q`4E&f(?NMK8!p!^n0G2x!d>ad^bSHd)^;Ax$;O0jWy~BqC@tW?wM{5CzhsVc zZ|2C;qk1~!fb_a;Pai-KYTae7eShBP{VlAM@jfAk+p$du{^H;3UAG+6_{Dti0Oq6* zc0kthAo#4%p|FfO>`5Fq?$9&4fd1BTp{U1kV--D;706fiTN5uUoE+%f2|=G8I(RMS zI1uw2clO4KO6!0j`e6KXhq>YBauCmPsm9CwlAFN4S1F#}@jp2X}Lvp_KW`0~43Ujdzjn|O-Uc%gY zMS|Qe;QdT~wgInyx&8F#`dIM0Z@esE_S~7vq4?gCq3nQa=Ur9S$a?s4@{`k?zCJk$C_q)(uOF(WiGJ;*jXt&w}vjN%W~Gs=DG zl-}7VFMWQmkS@88)fujFo@u*k%&C$z6#}wH>7vqZRDbkZ(pDSyOQsKE?+Eg=0y}BvV*~=iC z59*{*d-KgWSl~$u8B;Be*jvQ2>ohWs zD%P%@RIvAS!huOnIMtN(hj3yY2RVOrHUApRO zX9QMq!s6ZZFp`aIT$Sfhjhs>OxC)LBoY0y-|1;0<>l}54^%2%Mk~MhIJPcdn!*DlW zgI(uXL+}X0gko~=cf)XVDEIm98cg#DhlMrhkJIVj85D*|jy#XxIZ0M}IQo(?-t{yL z(X2@aH4jJcROU&448x8)>{I<$^FLYEC4)7%%GW4<5X$pL4gK62=8uwnoI`OGHdc0c2tcT6a#dxU4k|$&lL-eTCgzlUY1Cl@L@x{)74G;8aFiVf- zYkB6-l^NAHm^a;=e}0V~sd_y=@y~YA7|@cn=t?b^p~cq@;GgSNms!@|m}^m=85eww zR(F|EXhrAFEwlZ6qU>d2tn8=QNL7j?7g#WpX?w#_c}>=SCv%j*HnDw*~|B<4zkBnC2x5KeD^BrzM0NaCDKva z#yN;`K@*vG&q1EkQMWO~B11iuh)?C7MqMU;X%@+%GcMw|5`X?pf81sT5<)G^$7asq zlwUHkfDEG}S*kM@$r)#nY!BA3m$Iha&>~Y8{}#goB?1?-PRjbg`9BqKyQ9E7zGn9X zW)|2mQ}-Vw0xp$FBi5Ox4^|>=qD3C{v&amd*}s4HTZ$6=kd;T)u%AE9KO@6v znOoS?8(sSPA=t+kFYW1VVV$%6O<%a#(j$}ahp)d_51!%2d{+A7+6SPh2W!O<0SMva zn$ZC`U-dulqaUny_@f-py^E>^;PZX5Tf14~jtO9|? z4Kwz(MIzQG3NvP~Usc#w-!Tf6;&~SRlfC{M$w~dCh38EA%WUIy4Y%QF5=KkG}xzamW zL!QNagaORj;^U={qu|qB3x%(V8IsJtt!RQKG7I^;$VBI zOt`Ngi#3hUZNw}r9nYE4S>qT&Ch<5~DgJ)yITO|{Bct_$EWudQ|77X*SY*OVAD*MX zG9mm7GjVU25cxY3NApcU3VAHnC7Simg7OY|gI4G8lsr^ujY7oFFT`SX5yH;V30KN& z=y^q$6HBk#ghHGr2epIz;kcjzTzFA{0mBOE;wxfLC!aI25F=R6INzlZKO>n*{fy7? zC_-)v)}*EuLgPfPVoM>+jf=2|+`!@x=3`Z3jiKUu?p^u&WFO52vXBi6v1&eZ4evD- z_u0*)%GTym(a%om9+8YKf}^PH>b{^HkD9*;0;u zbde$9u2Rs%Nv<)gJ;T*OBKdn|vt4Bt=sSJHoc7}?iGR{ew(WJ1iBlcrK(4*CIjWL6 zYnT(i$X;fQag&DDPEsz@MLv#nla8!$+*FZU+*c;HzQ3i;kTMCnQYKY$e~WT*nGEZv zz_{2_iL#}8(VE%RpMFbEeyzaRpq-Pj+!v;GK^T^xMhn{>%Hm zoF7Wg1|XU>muW$K?1dj{#WM%<1|6qg>A867hY{y|a5&Wu{uh0*XN(_WulmE*#TN&< z`C=aHSNQ||(J$5)!-ITbe(H(O{2C_wYH7mek69ROVCM8-@2+itw7}9~0xrAo4rYZ(sp(x6@n7@10>oA-?kambkls zj%{+G`81xG$~kLH?vqsrxai29WGBq^a7NJ| zuF(GC9zEQdzB6WIat&v;a>mW=E>QTXVC?UNh*2t38cbHC^M5@ubT1Y=W1O1`oi37H z3{_zyof*}>sW5S~3XO)S5W=-(rL`)I=ejV%$r%9$op5&wp9fdW8>2$dzA(&Y9m!ESkF3Dix~Dvb|C*4tHG%=VR#b4T4RZZ zTp3xAQyP4(yBxi|$SRH`+qgI!9=pOYo&P`XWf-33YS4B$*M!x=@x?a`^BaUAZM_B~ z6Y2QoYn~||jxc{cV!zY3t)=T^Jw06}IvKhC3$mvNWgt1m^9J-xrSGgJdt!q1aQZ>! z(Nm9dMgx3V>+Cy+KJSBM8oBPP5u`_z0eaM-$0f$B!)?A+-$VljZ`Q*mG#M9a7?G$n zp!o@MA_ti{)L_*~>J$;GdHKJRQUGnR8P{zfjQ zcO#?Y%DUbLGaUWMHSICu*$QTuf_*iS%r@ova~Gepe~cN{HhDN%{C_-Sa6NZ9SJ+OD z?sb%{hg`)up|xxr>MmPW(z!cYiO1u}yT>W8b+#3zBr744hNAShFRmVCj|LgJayG)e(1e=qE+`kr~?(qR@`x`afk_M3Xn@7Mq2{XC{=N znT1tcn^-u0K9A?Pd9DC$^Na9h49BJph3GYfzDSOBPrEtGl$&HO%F#JK%SF_5SXP|p zEH!_Z%3t5fTioDWcZ=&(lM?f4vuCD^j_;#%Hof|<7selIGxI1N{88|?7T4C2YuAuV zX-Yn>ix!*CGY|4Gy}4v%hK$HU+-(!Kk&mm3EI8dR#MEI$SXHNxXS!VH6cpm~bY?zt zol*AERWg`+eZk-^vn#a~Yr8h08ES>kJ*;p(mwiFZ4*hsZfzqMmVqa$6t>Fcz(;CqhIWK zXh0T({|?~#TFLc!pH9*E!FBKZB=#KaVn0A$CZ@V(VKYC!biS7p-HLG8s|fdb@0_n# zga|vXAL*|<`-E=BQ^_)SwO%yilBH!>s*Lk>!RSI4#2!)M)<+i{+2M+yInJo$POt5U z5L^ilXQqh;sqZ+(#c1%?Y9lhM8}W*q!_B*Ttmc`N{;dIT$QHP@&O;3MfSwujHgU|T z(VYHQ*38F}El})GsGp2gsPCLmsQ1Mx)V15`WYM)lvZ1eDCern1=$0Zz_Gt!uR^eG= zSA2AKfytS<4uLMXu#5~wDfjU|=tv^-(EmEe*Q3l_xJ{mLqY;hP8ByyaJzM$oCS7Jm zLK(-%(Pm7a$Z@S1eX$O?h;2d!!@-Q?Va)uwLjH_w!BW;C_Ow>0oyqR0N7Fexn;DSX zlBGIXhjuFZB6+UjUZTR7udbM5-3n{S7W@epJ{hcS>#d98QD){l-JrMY4*h+e`PyiRUa38I?Nnw&aE?hsqlEJ3)=aH z<2T<^5SbJQGJ6N7)4x?a9OGk*aN%bae#C&683trFH#Q zcSaSS(FBz_<6bQN%bdgi%%7+v5O&9i6yI|cb7qob-!3^7Qbge~ZW;vOVLE)&p zT!SI}d@4*eB7T?=c_uvyLkv*e<~dD2Gfqw?mlDSJMFv0fxEakun6*l$=lfiRx_1CS zs|1Dm5qZn$%s729)?J)J+KS_J2dT5nLC%hMm;L_EQYYIA85RX}-0vi>BD>c>i2;8r z;dP6yT=>C;5%|&z(7BXjyYh{knam(53GgT$u4|EW(U-oivcpG`L+F2TE?Pb9p z1*$LQ{wj}qsPrA!y%;3}lD0S@LTf;dc-bq%E zZ7x;Rt>sd8W@lXSkfRlyvVS4~`**U}^JM`3 zJxmtA1N%4=wV3V8GlOngyzr-c`8>}G?s6YYHIV?vP;)Nm%^lvTm?Hnchpoc^xI?0Lv7oOQTOD{doePXQeVU|VAoG*Z_Py=7+k^18}1wefp!w=>4HZmt#@LQfRTWLNwe*^Q?mB z3f3LY;l&*jbIr+Ea?B2Op$B>@_b~b*R4XY&jSKA48qa-)m5W@v>?GeGvp;u>i!5N4 z!k0bva>-AD+=CX$oy%)dU5Pu76zI>nV?`roOI!TeTSA|fE&%WNd4=-aXWv~dzFcIE z=tSN_f$U}Trb}~nG-kD7Pv+7r6m;XBj@Rn6DvN#T=kR4~A^LMppJgn9rI5azeVpe9 z6=Cyp-aoxsi*1pcENbN{j$d0#Mzc1uCs2WIHRu<;!1J(A3ij_<;ow>&YFGurV^09` z&ifSCf+jOC&wX= z9-OacaD1L^#zLNJj@ZX~#Qj`U2v(@=H!9S2%y@qDf?hqPQmy0|Fs**FG_69%ajioV zxt)8mUF6|Q45Da5t~=WW4LA38eBiDLHBOqNF1cWqD>kUFJrHL zv>wri449?*kF7M|`A_EdROgr!$@5vB)n4VCQB;?i(f5Rf;rimLgU+jqzTnoLev4qMP8j0oloP9M>_>Q=*5?7xh;1PLv??EpAsTm&{Y1D`+H#GNMCS7`{hD3bClIaFOJNV4tamet z?v_C|y67alnUUE*Dj3eGurAdZcZWFR1K;0<$Ij@zn)Ph1fo?1c!+6dU{>#`OHz^$7 zv_=T`Uq867YFmqaWo?XD9L4uHAP-+&^SpeL8Rw^P4K%@w-(=v|a}Eu^tWdAuuLWe_ z@ALi%e@o``x>1I$N|sjpjMA{NUOF1-pGeosi&$n1e08RSN`>^Z-0MDb!4qbd|NDgV z=g@HWtMGFh%gpI!;TRhmjz_Eogg6_}!$ODuS3UZ$XN>D7|uTzT~5Yu{m?7f6IsSUU2Cd z38#om^jcT|Yq6D(v>)=GXJTGfk*Kyc1C6#8K%3S`UON4haY}DA4jz3{SKBx3q!V(3BgR+p`%#vJ<5*kAnN zQv?=gWnx=2eQJ*zNeHc(W3G7NSt^OE$P9!}E5PEiMsjVz52;5kW?xPOem%`Vh&dlS zeHzMBZLyrY<&7N)%ov))p7<8@2ClM}O5}qM9`Ql*a?F{v&BWMq?=ay~L%H3EdCKR8 zV8Mm$=w_b@ZMy>cBI?UK=JU>DZgLCfNYs7Bv*kt11)gssF`X@v$2?p=p8HLU%0O^p z0RnwnGLNl9?v3z1g$0s{ykdL5GFtC~QIaeY} zy8EK_@<{wFB_DT*dEYJ#}fu#*fbPNweNCsk2f}ukNbRxE&_)F1n+GoHUqxNot(k&+ZO@wbF5R8k9AQ^q)Go0 z>0L4ezTYCzfjrdGcl2OZYa!_KTMCwYV@bzIwC3maWkWvp9%&>`w|W-P{hyt&mf}IBa>O#2-uozo-^zr|Fn%t5TFCBQ z#jm@$dG(Ip*OG>A3t@(3yHCj*nKGjUpo{a-@lpEDETF;d7u2oZHL-O5B+!P*VPAKvgy+-VZV4%0qTEhAzO!) zNYyspIK=A~I3N?d#}x29%|@PVDV5926YtnK5<9cV^A4bo@?ljTi+u(rRU$t~zOwI*5((ql<`H?r)+aK^>oNbgUPC#U zS0YcDd%pi=1orcF6y#4Q@xC3|n5FZtgdtOwDj zd87_=aPHem^)Wvsfqu_tgCY@iAQJ=o6`<)t8~OTyx#Z;da&Iz^$SDI!-uY*f050k7LR^4&k4yn`ajR`iWa`hw3M5FdMb+!}?zl^j{`mf0w(WWnv- z^qOrTvv4v5d&m#o%E`g*z7{N6xlaQWfsGG}^G$pB&`%fIko?_)Z1`O+gGbd^ z3AA=X>by{VyT}}BazkdZ;O`pr8@_YIu1-OiQ24oH`CjUKRou7y81; z-&G)QIB0adbTv8R_Q6ne4<&awDjW85m~UI_fJ8+)p>B_0EJ&o6FoyYzH_Pys^?n(| z99YlWp{O!OhlF6B4ad-T_W7Ws(*IcN40Cn6=`nwP4zr4QoxdNHvs>*^@+cH_d+N|M zmAS6L798+Nl!?s6-qJ7_UX7Upz9t*flP!216DMOAIl$$wAmkm@AvZD`L1qgA&n8I! z$QI}p8ia$TN%%;P(qW$k+jQ|V^R6RGCWpW~jXYgw4%(9+95g;b=InC9!h{ga)9SF0 zzPU=|!mIN2YhK8iYG03KL4FOtj2||iDb=j2N1%qOvjPE`k83)sHH@m#k_C(>v#shI)JeZvlktaFXX(IDK)5YoP1W73`{2<+Pngo|ti`a+PtsTcTqD*GeYU5h^L$v+CuL*%Gbp~vvgr~n-B)FCS%1N->; z8+t^_1a~ED=?(OFq=kKP1}3JK!LmWDgpFr!@W1}pY^g&pJ@cA*e|9|^AunIkmp3N} z-}}?g_$M8k^rbMajh55jZD42-2)}hYboiT&SLF3doMPm1DRYf^AJ)64#l~0UdFzs2 zes@H=^k8yy@=Xbs-Tvq> zmR#gg^1r_1E~`h2`wjXEnUn5F9?-2beXJKsk$fORvMSkON7X<)TtF{j81KXR_4i<{B1Eut=FphwR#H2o4K6Pwtg(x4z%m(xPqiNBZk`I_0W za{h-B>(|n6_*;vWYtqRoaPM_GS}e9G5i*g^w-H(#-<5&&_Ixg`M#-sOHu!TQ5DR8$ zVfBkV^5imPrA5lX7q(bJZhAS#$?CD>C8v?I-V!O@S6BnP$u+l$gYhGC$)A3=H77an&V8p0-j#x7r^+7qI`# zG6PStOHrv?l>D7)4f9NY_|~N-?oI~!rj?>yS(IFyXNx2A12La0SD$g2*xa8v@_VAl z2-%`aXFuHKd~w2$oV9`Xl_^ThLT!=Q*dLv5X|ZMxpO-cY*G>H*<;WCUyjc~5_D6IW zbUp)PK9}O~r6aQ9kuBa|<@LYA@qb<>9`O7BfBlTrN5vZac6hlAe4To+WlrOim0PS_ zDp^%Dlud4DxTJn&*j_8t@J~^K!86S)W#9?5!6u=;VZaAna`_q6Qw~l)W=OiT*QNET zwB+F~!7hJ>3{2VFV}U{A8(`>o$C6_9R|fN#HHOur0=u1QT-#u?;iI8b{cSGGlc#hW znH-V4aI#rSIqTeHx0bzD-pdoj}Vh*la`(Mqd` z1gSGdD~5mLq;6DIS}^->j2))?+mR<>Cc-Ku_CL47hGuH0Ym-Ohb9rIC1CGv9!)Z0M0mUFYmCeW7H|aS-x81>wnwZzS>rfAU56l^onLFN$2zSZ&+~NXT%^O50eaj?)ZzY9p6$QZBR7f+ zvO$O2U)W>tnO}dW!#O8Ce(>zAWHNI=3i)@^nDbSQ%wuIeocS}GZPa0iFFia*=v}DA ztgq*MhQ}}i+ANb^EqZgl@oau3>lgN97R%^Re8f3%6&(?Ynb_x(g~#_ZG2eoI#(m6@ zCjabIF$;h5Goks*9t4iB^|R^nIhctq2|PFI&Y!iCtYag(6E0+8+44fbau-;6bqRd(XVx@WKPw$krxYccFoN~Ho@X>dm=H8u7!Vwp-_thW>2 zKx^rG%|@!Xv6UEi8yOJUN@~%0kXYSH2F`F2e|xpOCu_B-wT(PZw2?{fWFDop_y*Vs zPTI&@vXFgxIY`^=4l;IHTj_AnS|;vxka?A?q}SEPGP=A{npL)wu6@jKw}ei(m&HqE|x#dOXbuO)-;ZLp>9=A9C_%4jBK)02Rsp*;fb_l;h<4&E?~_lDgBFYL`^p0phqMIUBNbqo6+{;F9C_kF{| zU{Nj{&l`}bDj*9rkM&+}@=?#jkV~IUky|)Uke^Dw#9YOruPwq+cNgm=ufs6OijKO9%zEBU zZZX@4VPqTo1sdTvG!4@(Gw140Dh?ht!kwSTcQRrN&mJbfVqWe+BRn!wxvpZZg@2~K zNkvkADz;3cU$LW+Svy9gu?}405&6fSsd&oI7xH_0kiWV-mATX83VhZZG4ZMqUHG%d zaj&ErV#Kr^M%*YcLGd^j39Fb(dyS67`gs^M%!Eyq>2+G3i~cK3_~&dcuAVnxBLBPR z8~Q06O{kKRi{5K;v3PuF{Sxl~gr zaXJUF-`-lj)wY&Xu;4=48{NxvT24NM! ze%j_9*t&>5#_FDMzUs+*RQe!U6Kpca3v(NIAz0}}w~#02Dlfd6ABJt2VVD-qX9!_9 z)rI%{xiB0V9ELtK!{|x~$E!MF7|D93uXz~8@Oc`L!E@7bWOVwn)=55b%^5O_>HKpw zGox#UVb1}cyZt2dcsdMod-Iv(=ZC)YInLuV#P6NOpa0H<9!Cjdu1pxF^ds}b?;YMN z48Q(Og~bvh(to64g*`dLFnSvK95nDU;!>s&7n12+OrwjXl@Z0`jQF^lS#A%F_)-nbkaA7Eaa6z%?;a)+0_vY>1QE&l1FJQJg%Eijx}dG3>u$cIELHu^>P4XPaJT zor{w;Z{j6og;t{Cw32loK}w&qm!?ykjA^fx!mv2`Q9&oKV|7xUIcBPJTIv5=E7j<7 z{7rtbOFtEc3Hij`_NW~|_o9kkl570ssPMdmbtTp&tMygE>!Tf}m9xXIU#tzDCF97mo_k~Lp<$h{ zT`0MUnRc-JSA~FfDzq}QN7_*Kri5x>-kHut?!8LGG#CoHylZRFh3mhLJD3kTSp(Bz z4L18}u=aHj9U;L;W@{k8Lc(Fu-EqyfTXU{G%t{pR024THghrlX&)Xmi4(0taLw(Ia{ z20bHO|1~*44(JYDC^nTxLN$(w&Ww%a-I3F4xjv)Z5^#ctyC=rJCmP$ufwsE znTQ&gNk0@F+GHAA88dO~8GAwRX2O?y<1@*bs87!EJ9(0q-`Pu%Gx+q&E)j^G3y!-WVO?i;r9n-Q?Qh&TTT|zn1&?YU6 z{D_h3a?anI_;JdJfIH;3Sx0x{{5&R?V?rXwkEZmuhSJX(L;v5CwzBC@C%JE@mfVkO zIl1waFF?NW<(Ad~IY40yLcG-;s0Rdf=fm z-ASkOQ2wo>+)8zndea=`#TzR*VC^X5T06@38k|QPo1ynGb3AsTAG{JXJNfy=2i|C) z^TdLVzBpP$4~XME$-^WCI<_~% zt4K4PNi;_wuhHEKWKgqwFsqL@+LU;s(I6jGxkVT9dmnTsySQB&4$Ycy)Z+U#<1zig zd&2RabBsDR4F}H{@##q#E*Fyr$)uxk7Fot~CIlPk()9U{lOgwRBKN@S;~nTEC-*vv zswp|5%r+9dTq&LX%#dGThHY9iSnes6({oGZb+Q7Fv~(-4_rZIvn`e3WV84pJJcoR+ zy(kP5E^^*H%*@wMWGe%9V|kC=yq2kG>urSj^fVk`CuLzQ`(nnY!H@i4jcX=MviXdb zah$h!AN_2Xhf50_BsrnIoKI28DZRC{3u6z~YNhAp?O3`BO8Como zUi8N5U0&$;%L}%>z46h}7ppfj|9TeluJv3mlbQL=>vFNpZhSRxEx`Nd(IPTMyl-k& zNyFTxX=q9&q(MvaAM;FzcH;ZSHR9Qi%zz`~w5qjM;>f7ye2V8eU%WJbohUc_xYw_1 zkKT>daNE`vXUL@$)pvm65y#iaAk4o`H_?6#QaFaTAe+7V7=5<{QWr#N3z)0wk-?A$vmU!t8i75k+U+;LC8$Xw#5q9&N^mG z4^EUn%)GvOS1*<&dg(}>@VU7fsV3$t{#L`Cb^Hm|1Cdj~PYMjeZv+vjee>C=3c}5Kj z3p-q%9gIsOHMrI<7~`5~fRJE3?HP=%!u~^!>0L{7I60fy(>LPrp+y25yUy|qLkF$A zd`kb|7iMwW+XHhQFfWc7Im=WSZ?g(P9fPsQE*QUaH2>pi{8fRk@eRlQWz19V5|4EY z=^<<#kB#J2x|L-jm7L7RRK9QH=^`W7*nLSh{$Va=B(u2F`El;9!c}W$=9)f{yi6Q< zQ%Mx#Wxces(26Q0PM+`4$^*3;wVl|z(8C@UdO?MbIpKK;aGi?Uznk+qcb!i!84rZGPvF$)(KlfU4Z!aKUi`n6ZM zZo8mxy&0r%T|lnUjZB9BNS&lMq)R$VD-HU_%7<*NTp+(wy|O)alR53o*Y#qb8sp0B z;a05TH48$Q3*;#+gVD>#*TlJc*m?FVl<3j)dpy0XoQF-!$S~t|8Xu1Q5;iHAlgB=+i)G>!>BAa_4_eY?w_}zMrdJz*FP**NaErZupTaQM zCJduvxsP@aM+eSfOEespx3HIpYw%L;RaFDnclUsOK-nf_KF`J1PI;)DOxBy@&z=i; z2x!w;zRhSar^G>OzqXf7=jiL-)<(t-Fh{M}aK}%6AGi;9WNyL<<|*!@b7?jGxi#1i$lpJV<4`L1#R=OvHXcvI z@mD6i*qeu+?6oV)pktkVd@s%Na5BAvXts8d;6$}Fv9ysso^52%s4nvNz8QuU@Z6=d z8CJhkp!sWaJfzq6*EMg{4QAeS)CgQy;tP+8?Afg5i)Y{2=XEa}jg{f3{Vg23_}{Mw zaDKgFgtv|iet9yDZ7#w5Huov(>5P0xhkFKHh{5E$cjcktz&t$Y{uvKnw37v~ZKbMD z8>v3rNw&n;NyFI=@*~F#qxjKBYmOuCCE_|=fh+#zSQ^Xq#%;2vEq(E8yEnX3d{Aeb zFCH%nM|{OFJnkEgwY)}yj)r4#=iM0EpZ$@q)6k|-8uk^C&2P`SbSiV69ZXQ(GQrA7 zPoy0^gxq`VB4?>N(^h6rY%gD?sAZqEjWnvLmd!e~j6bS?AJ3vnBNf}Nev>Vpp(z3}M<_mubP751X@cqaFfobRjN49C%6Ba%JS(5W1~ zjGRk*^<~eeC;Jw@n=qB<3g2h2zmoGt@;DQ2)XGEc-OTR{S4xL_YDu1IBmcxXivLDy zS$mtWqn`rR+7`>m*St2NJnIS|r`yL9L#@0qsizmtk7a)V_q|@fy>Y`Y9G`oIW9o)5 zBqq?s>>G}2<#>Iz8L@)zSs%iK)#Du$b^5D<&lzW{`sKM8C_6c(; zESNLBBT*Kr;-zsMYfRVl;*zA3szG$aUts%v?cet>Idw-i0L)Q(5;adPkvGnvzqiP4#yD_&>PJ(q=)W$eeHziv2L zv^^OL*U8poz*zfwMgQOAUP;pKRia$t__LGa(6J^7GLHMGh&%R3kK~-u#R2|Z)R;_X zt&wNvLph%=U7^9l7OU{$G2M|5=xTgO=X+~r7W1{JPU*0}8C}N)J$g*xoEFZtH^=C9 zt1>ZRHaTjZ$5!BYophxPGi#Z-{v}J@gDkaz{JTRxGuK6r_4512F*!IrLH=2tAiFrH zPJWOeT@P~X%VOTqAo8A^*ISQPdwOcgU(VeWPE7@-MV6-@^fqtn5Kj+dLzgdr% ze9rA-^tfE8!{vMAJ=?LbeG4HS#;!BZk+<<+B+2<1u$fJe1t?EZIz#uLFDbpRtcWgZ)-PTx&$|n%vKV{z4YBUa~RZ z1f4b;%v@LIC|s{`E*rW;;abwo%yk{-^dHCdGNB4*u@ap$;JvdhS1-zH4%nEk#{I8! zE+17PaGe^i$5b%v2}1dp0K}AVFSkR3vK_%Ft+fh@S)8jL=`mqcJeK%yUVqAdvsQZ8 z7PBs`$i{{rS!n8>jXK`h$nKJbr)1x+^-#FhWr8th(6M?*fj(_r?P4AH=! zbJmTntQ!pGeZ+aI_z(L9#_18y9<}&goY(u&H>zUp^y(}O%g=%>=P&1JTm!`_TrZGg z^k(nGo`L_5XDoVbA?2?XihGG0o=y#A&MUoa4!LNhXHKhYvApWe^Sf2UR>)0da&|2o-{VUT_ z-BGSy7>CZ``QZ{N+2@AvHS`-sry}A|F7|wADh-%}ykzij=5B`I-dLWK z)nV?(+~(4~QK4*M{_MUVp{SBg4r?kopb0JH3H@UCo_Qj@To}YP6$`I0f9I^Nw5?qt zi61-=%QNpc3id!f&B4Tg#?q5Hzq#Mt@nd}`?yV>H_fIaWEpH^dW)zC^Sx-zO=UDum z9z$pL><+P#Jwl!_ZWx{N%(LFabL~&Lc&Kh6yUD?=ec+Cr+e2acz_R02<_@>0C&|N^ zRnyiJ{p$1F@JT8&nfdQ6YAW}){gI*qcf41GV%X9Y%xKQ@x(H7Ds z_>a_oG8}JxLa|Rz-&{C(LytysT3^U)ayNXL5sDz*Cr$Q~6Rh4$wucqS{Ok0`IfkHW zZVIXm$;G7U&BXG1p>&z#j<$v5?`9gH*hTN#h88j+k7@3wJz=aLO2;GfyF0Om*}jR) z*jXqkv)!W+@Z^jea)@+G&G9cw9u z@FF?2!yPaDLr{>Ag7d!2*FN4qU!`OGQal7jjhm{;Dku`obRCe)xOkv#8( zXx{&dT-MWCNQ=RLWnzLmKG!54w~z1FKip?8Z6u8w7Ko+79ZnzUhcHjY7xKSr_B9m; z+rRQ=zB}%{qIa);Dvs!K;M%;EG%qNS&J*3x@8K?3bWTN8r(C2AZZ3(YKavx0>Cqq#wBL&CEmrWR} zl>A|363BX$Q+aZBHI3NL=lXZBg`DeJD&NR0_P9#_X=na>o8{u>!UpmWJ&%j(df-fB z)`BiE4|;nJ?k=;I6D@zs`NM7~yA=Wtcjjx?&xLz&Gda)a!h4q|hI9$VqCu(1IQt1F zD_O`KQ;8g{Nk{e}@^rjU4%>09^0%3+C|4r8c>hX2-$(s68)m8(%hY#n_6DUzG?Jj#erl=Wfu2VZ~8YkCIre@oJGa-G{l z@GO&D_7V2g*JvT{?i9+rT5fbLhvL_vRQyA}yX0;wnNYJp8aDO7x|Z}^($n#FLN3f} zG?xi{e=W#gcR9gv=`;Dt=o~z~QCITY{S<99?>9vlj@L`Y)k*Z6@;ZmCE|7A6-EcQM z6h3?CfqnG}E1fMRmE&H+>Tb*&BL90X1%IC9F#o_>`V23YtdDNk&vDX$*KOzX9JKFb zDgUnjBg=+zJggatc?XzZPcFM?L}Rfz|3}6?cE{g2p?Ec({hYPwuc>NnTiIjlON;oG3pn`!s)SGnPZ{)U4MavU%K#vyq;q`sy?bgYp8>tji z93$oWaU1A7$kR0;Ulzdn^@K9!kVJ}iRcm~$%iP-!T0C4yA9NM^%QBOxH=^31Fhh2_=xa+5dtj}P77;~#T z(+4-g4vRNvu>XJ-PA4)@lbl*aNsK()Z-+|{{LrU5xkB=HT@IJwQRQfHZp^&t*Z@4} z!2bB^Qu0Q1dcWWR9ovH9I)Y(qQxkEu6b$U^qQ-7nO0cuagpOrUYO^ zJiU8Lu8muekJCrVpsM7mssw>X94sL>;5)Ju-SUr0V?8-aa(|b$@#lwTpsQ6GcH6|t zr7U_39r-$w$h&>dz_j8r9G*Z9Xqpns>Eo;4pS?T|JV!2NPVvhqX{A#_^Obzu6CI4R zGx5`oT+*OOX|q#_QA3z({6LHGkJ53MUQ53dk#gm}4Xix;k;VMqS0(8@*Dix;ZHz=% z+G70`Ke)Kkdw4t(c@@gI&xnw<%%QHAy%N*DYte2ExxZ>WSNNAanzIeY_V>rRtvYP0 zo{4z=dq0djC=cl$TyZrJjXLTu?PEILSLf>)A1M}rNYUAV@i?zGfMV6 zumNraK<>xldpW)@Gs!(|ij_31Kt4(X++Xp83=e(-W&pYSRA z_-qxf%g@9~g^M=0*_~dk-Q+QO|L8`Ot7;M@^Z9cUCk3JE4=u_nW+K+1434}$Q>!cC z=Me;7@@s=eWH5)K6yLHUq~a-h{pi=5xkig?^)m3yybMd8Mao25Iw4*L!r>3Sgyg^0 zhLRio94To-=+jIKz^IK{EI3F`)}Q=ruPAwT%m%d&25_CD#pLlBxZju0OO-fr@5Uak z$AK`Ci`@1*1G6Ga;oU4+I*<##*(DI3H?*i=&Fm(=&Ku;vek`|znz`*Q$?;7i*B0HW z45OMv2*qFMvBM9^=H&hw@qTDcZnRO9IMKV8Z03hvd@ih}X5iIig{!e@gp3-m#CK&N z*75o3?URWOyq-0`M99Jp^mxu@jV6Kl$h<$lsmsu9E&01!wy5kIfUa8RYp>0K|MfE5 zSsEqFQf)BePaq!f-`lm6{>pb{=wlxvyE@t75byuJ!{V^MN+y11l#=_1mBq|$A5n!l z$PKhG)+Tc^ikxXmlr-<6q|29Cuk*q+M@czn6=LQEp+^OtRkEHEL=N=9 zt7xe=L&?kt`u>LSdB4E?^dV(*AI8f2Li!@#1;M@#eTC+ks6_tPm~}+vGcP;hq(3Z` ztmm}K!0xJCzw4r;4xgiIo&6C$M~ACB(~*CkK312bGH|$xz10ECtI&Zj9+RBQ&^9|l zo{@hX@|K>^W;%F$BiBj)V5Ou8DQl}lT%qMp_ zJsqnTmtk#QtOOrcqF;O<`o_lLX$0R#Jw2ES{Qi9YoZkM}LVmVcwM=|^TZ)crV&$gM z27`A5qDw0sJZogaE}i~d=SVqp*ajy#9?qS}UdIf+PA^_JzoYWWgX7Fne=LjDqVptj zn)KUN`w=7ank(_GdjQN>!%HUj{d^gD+e`d8j!M)#;g1_paY*O$xMfr+4vdVDo2hm% zkP|;$M~m`h8Ns|@`T>Sa*+JvLgrQcx*0ExT59FaI%Zw>*NS(I zczL{DjS2QDW^>V#@L7dEj7kq4>BO52IA@;COME&+f_PDs*bC#wj~{ zc*LmDh4qXbAxc~wtH#;u{J!<9g|`hx8tWMQrUvp}4MG6x(phF2o+|`mJ?qL#9tNQ) z&+%(mFf%YggN(X?sI3pe;Fiq$Sf)YhG!5KrnGHprvHpCXb#Xmm`&)zJ0rdBD3Pf6c z=4;hsUHY^JA8V6YtU})o&!1*D(qP;mW`*n``#6Qab1u(+-Unfdj~)j(-_~oZN8uqI zb~RwuUj}oeyYt*7M~fAA*;8sFtJqhMF^%JhxbPTZfmPT0G|eFYC>WCLL=@o#|X47x{Id z9-*W47^Ka_E3&@LD`%n;>jR!HnaJ9ig`wUV@O0<-%ETgv-|dCw97fVGQf|sVX0w`{0R2ZeA!LXZ8KACzLr}bgX;f#b$bV$SZC)d1C2Fo->zt zA*;SOvXs8K$e*9z+6O}mJyE>L8y?p^ahl)T-~_oVdK(Xue=^_7n#G_nXjvz)>qA#u zd>DM4!=QAbXJ{S0iHCNh%FQs?WwSOPO80zl7@6N%h;T? z534dVRpb=M7KY&>&)Y984a2YpVQBd$41R0LJd&~6TA6uPbD0zQCluo*gyHiuo_~+0 z^RWl_N9R&8sHYJHi;W0+XT-G&Mp*A5lQ1fcwK>)=F4JAnnCIdbQ!)P+{fs=jar%}D zd^4iL6LJf$jj*|9#F*`@{raV%_DLhEgpg?*YsBwrM!b4sgza&<;^va!DoaKAW=2@K z@_gWn5z&Ek8nAZs;4WQs4bl+2+64b0CVcQPVdMcahZ{{$4>w^IS;Y-&Oh_7GLeZUE z%pnU^{w{ebPu90*<>GM-Iy2I9af)XbHLI9#P|g3x^Ll05Jk;EphkAc(`w zg1fU`Q&23W=4RL)#b@MtiS*I)xhg7_m6OV3Yr_(G;?1n~!DcwWhOWoPW+=_)9#_d) zVN@w|G!!W3&HOYzW4(AbGontJMD8z@+@@xjcc%4pXXJ~XpiOd zQiD9>$}mJ;r*~;aI70QIc)v0ft#7eb=M>H?4AwGBnblPx4EagnC}OQ_ZB#ghTn@wa z&pfBS5{8rHF19xd$If;1eg)Bi!P=*Fei*#Vk$oWl@Lw(I*GBqO=acKUr5o2-KoruqC{vW@llEOu8#DrlDOn6?vzGpsjdE59r@_UAFGGTlv&&Fnw1D;FY$V;Ac3^1Xs z56_k8unC|iwLPEDa9gs&=W@|&IDL*}9h(>C;*4b;5^I{^LQW>k(uAz?w+xZd&MsG) zr5fsM<{J7<6NB%Rk1h+oE-?%})w%oA^W$9FSU)$cO=)8oP%+3bzRD=Wf<20q$GfW~ zZ*@?lEV_8!;I#JT#o5gp8Z2+@>K?zjP4^8yBa?e)pEc~QY46fC+{tCdiyg@sN8^&c zzWW-MM{F_dn`+kMZJd+Kl};Cuk5(}zxBI@x#s1(ogZa;Nmm2PI;-b~bK)Ms{tjQ{V z(90&8OdKbS-ae=#@t`@d3&f);Hk##A3<u2Bm!;d7V%tADak?@bm=4cOCil673J;ofpxIIJIQUiMkYzMqMLftl!QPv$U& zXF44->2hFx8P9{dPS1pO7`@-e`1d~3+t0t-@(I1(i?ZOvn&iS{?iH}&E= zacm|I@oQ^rvXJ?K{cOLpup=iE4Wj-Z&shAzQ7&Gvm634{a+AKKezhEAZ**I6P?p2w zmnBl%m-9ugIjp0KMfchaF7Lh2jAL-icg&-7@-_S>rQVI8OC)wA6zT& zhRN0&%{-VDx*!Y+=Wv`So9?oo?BEdA_&?BrOYXw12K~1KFJT~GPkycuUFp?JUYdtq z9FKN2&V#pA9vaaf*)PLhUTEJ!pa{?kqlBs$0>M>`qX zw7ulerFm;dsnl{+;Po~-%Ck!3*~wDz$ne4tGhghai|p_oPxNl)je16Ja*N?e{tgOS1bsiGNnb6P3b=xcUsNCW88s{jNo7hRE{nqm3qLSGM4wA+ml0jUP9PUlNa$K48 z=9*_yWiy`HnBzKKRA##q{BtM{4^uqKA4PwyBa+osbKy{jgogNyr>t9 zg-z&YTpf(*-|H$1@ibk}oTzxzuq7YfjlF)S$rp^y!nktTJon9pfn!-S zjz?)^9_pN7Eq^i{hA+f+zn zujY(C4zMOmKZ^Xt89OyX$;GXhL)TW42Fm&DvE=yQM>r=K^zi2%{*qrjENkkqkbC<} zP06?lX^T;`J#r|a65!?p0(;p?z2RV5kce|UXsz{nZ~B=8f=@Y zL8MnO9$wYsR1W8Z{_$wAL63f%TYk`r(3EB*N2(+}w7DBWM`YI^26ktOUID-Cz(WaC$!4Y}Im-wkR^Xu`f!@-lU& zGIN#u;yu1c)#?Pp{sq~h+jJ$rXYFPaYaI1??r}CAe%08^xla#<1mJG||7Mk+c$|rf zcgW0_r(g3g=b{c~t_{bMOKGKWb(*4Z_0W+|(I{NY`6fyhGs2rp(8`-le6JeCOUt4p z39zS|aWmHsB|Mi}t479QHQL-(W7K%QKV(qbb3Px+dD`(t5H_}>f2&ZB7o3+z$Hn6f z=gG6R^{6$>}zj@>#3~@*LR!9gmhB4{#Umu zVZY?uO?EPFj=glA+eSJkwUsmT+R03wExf9vK&Rg381vU0eS4ZAwyPO_erC@T$Ky`i zPh6!Jv1)U=eV2H`(k&cWM>s!lOg1yny*`5bgGXWbm*er3!D)~|X&A(DxtpUAdtT7b zIx!C^+w;(jW8rghd)rgFR&Ha$_TC+2^y@aV=T>uhxWi6tBJAbTWP2(9UBPT)1%9k3 zl|x<1r27qiUfv8>`}x3das*P&dE+|I3NB}puXbdAz?V?O6^G-JuqWy~GaB?^ICg_v z!>lw^iXulHZ^WA$M%@0$J$6DGHgHY8xOyH|-lXTeCb_gOCS2hCN^BiP?o2}e1k7@jGOJVWPvzS)RPX6!*+!aQS+jcqv&c5uyu?@_v5 z7Ug0)_Yubqk*_@4MxHdVmu|kcQu?l?^j&Tzhq9d{g!8Dmrvf>?e`J$miG;T?gBACc zJ{{@h?@Om|yeF#j<3W-S>RtB1XwF+7gXm}Eyw!>C)3R60p@<;wsiYs0>x@QKFJX3F zBX+4Tp?ELdQ1!^?eK)~j56=V6ny}HF*XXecp@BA1%f?=!%Gt^H8%|P7=&l^fp2Fc~ zSa8Y=wS7ut)PPcHzeItl^LUoj$_wV)W7ZwxgL{#l*sz27+$yq!+z&c0-;MUw>4DA- zhkq1vGVH^#gX@i);5011%RV!!H1;X5pW>$xvGSSsBE4yxGj?cWv4#<6DbpRYhvusQah_QAkSV_Xw0;#z0*)-=pCPs3G*djOWxu**+jqs*PYa5dD6~$bKyd;2wm| zn*<+wbX~;0qJkidt{#lm!#VCWBL{YZZguty^^9TORNHv8JD_KMLPzc*9xaNQWpf}K ztBy0*<~=>NR_yOiVefXf!gbyyg=;lB{h_@R2Gev`^&YDBe4g8v*x_##)*an6h^V;= zjm$Neewuw-+{6+J193?i|TNUw$4jAPbGw zlaq@lYfk1|(?{WY;sf)+A~=tQ)BiU-LB1;Er6gV}-K)}{;G>g(?g^qGGq{4+=s_

n zGkHEeD+}FwWMRr}))K4Hhqx#UVxe%YJ&P{ig&dpLkSE}Ht-MKQ?@f}lwbF|@*Bra9 zu%Kg;6N-ayc4{!@R%2aYn1*}KU^w*&#*DLc zAT5bU);c8pW%=H!L(eQW7 z1DvgJ-MN7M9AoLNyqzc=R66N#nb}#~v)?9@zk99<@=}dk$5f~nsYH05JwofM@#GcP zJAtdvcY82$c<(2vnm}pmNE@XG0U|*{w)cJaIz_ z&$*tGhZ?+%XDUq_$crCE@@%0yzW)lPdz|M!>vEyF%G_$>FWI)&9YX_{Uy?xo;JF-l zS~L-lN_4E(_vHOc?<~)k0*-$~RYiSS`Jq6jSr3Qn#}K6TOGS~Iyv*KK(x-8WEIRH^ zCMFcF^aIY>k^|@2O~i}*QN`Jwh*7c!I3N|1M&{zLQ!|NqQY@Np?x?yU3}eX;9$1`% z?siRNO7#L!wPb#4PACSrkk|X~-}R!dTxPAnME_%&4SR~ar~D5O^|jDiJp28XGirW4 zf?mZf2CQwJgC6AR#`EY53uF71;&rT0jLhj?e3sW?Y6>nk%Ef9$ z3)U`5#DzTF_!lAQ*@L-5*?j%Xryeq(SQgji>+cncZ;w*(V`C2Hudon{_v9=8afh=v zJ(vab(EZLqs9QtX`jt80KRr<^oV=%`p!Mw>)ack$_E#yEZ2sQADxT%9O68vS6Etxx zrQ2U}i&N--Y{J*yirzh5x2GR1rKsW$xtZ^ddV~1$`M&s9WIyoBhVr&nf%vrc#JJ<3 znDr$UV_b9LJlaxjz9S(4nz*em44)>G^seVJ_nkA z8cJTLzf$ifbDZhlJW1YaOKL72*;~rWH>EOtfIDKE(VzGad!KveupUBxU$Z|lkgv0` zmbu=1zb4yr?%L8)HoW{RXO9g>$8Vt+wVn4BzwVoFA^KB=^2ON$H-)diMhYtNe)Ae* zDTi7VOHB)R%=HXGmr&*fd-C67)*YdE->n_shktP7P&dW|3H~cE_xn zp%@aJfV>)0#Zp&k(%$Hw6t_fA6wJa+K%vrwcsL z=0gZJKW3h9^&C`JSjpabMKW}l8$t>~@ZKkt^LP#vzLwHp+;7>imYEApm}$_7Yn=zV z*!Ivy*3$DhslXGBjUi~r=k9&^9OMVLmd{6ji`PLnY$y#yuoL-K2cGF(wvZC~6MyaJ zbCJZnqNfIU@5+Tmj-^!XS;+c?2NsMaha1Qo=Q#RO^IOQOM}H++;Q_nrA*h#QU}i}U zT3ED@Tir_KSF{J5bLnaIPQkp{IaoTnvD8f|lxBTB>GvjA`!fY$VL5PL-%`A#P@a-2 zT-BF3VTx4LJV~GF3M)~NUw$jYp~(!v*<&df_bCVdYg@>C@}d1}dtizUbE5y_D_7>i z^RA_gxbauYHRbaa6av3zDQMJz*V(&;Y)WK}gU`{nFaP;5Q*pCF4o(!-m$mJR1l=aQs@bGO2d3E|XT}`-_ZzXRJ7K$4=UuOxy$Q`MuF_c{MhWhfO_aB)R z;)y1yNLP}Hl+ObgDZ1TXY+)(u8{h&oEk9m37%cjMQmw2zTb)#+zqesSN+S`^I7fTghv+crf@dX5cDvjY(nqr*e4GfKnh z^?Mp2J9gW^da6HueWF{aDqTPi$lqBW5uXAZj!}V_xk!f}C3{o?Rml z-yGTF_&gok>EkP5e(r%`N{oK&kCh*_=-DA189T~wCL=~Vks~uq@rU`jI0Qv9=eMvF z#Y4&Ek$d{KGYEQT9V)cUz=(eI50VG;t8Is_T*rO*$-L<*^ayF`eftz90y$ zT=R}dNk_*9r5Mp8M&94I#gSHl*cHWG)J$@JZ_4QE)yey3N|?w=4Ve~)gv;ru$bZ*_ z7qQZJwGAA|8D;{IrGCGzMyyGRbGHaW*b_ezoT zEkca+omE-ok6LkB#Jx|)ejR;n1ESV+8kKZuuU;^}*tQhww?@c>7dD7o83;PU5i~jjWPAWzC-YD5kesjV{dH}m?ncGHI zWG#8dj}go|uth8Kwx-GC&gj!TVkpB;|0rp|`*XoPe;ggCLv&N-K$VtaR`VD+yuk+7 z_xqzLg3CXFhGumlWl0SsCff51D@=!>*O}A(xD?x*qh!6W5=BSp*E_65)%XmQ zye@@P|0s#zeKmFRz&#=-{FB<%MRT=j2k%I~pZ+=1LUP zOSpzV|4d#6e#Mod%0EZt!gV`DvYvB-yv@u|zVCmS8-65OlqdP`O$)?_b2?nAlz~Ur zOId3rhx^I~j>}o+IjTj6n;9r8DW!WVQlf*D80sE?={2-SanHcgUu8%n-*;N6#9VT_ zRaDI2`uq?T!{}k`6eaz)StE&l)z#DK<-C!Ok>%MhyE#Js1lwYi6&)G{T5Q@!p89DS zdRLB+1&(&8G4ubB_SSz53#G<5dCxi7^f6L+Ke&-7F;86~Rf6HnpZ_}Z z5cM`tU-ev^+*{#>sc)C#%PjKL1{01(Sn=|BtPrBcmJh+GF;#~?QM{g)t@v%nc`U{a zZg0sgHqm2B0PkZYeaU+!Nop-OJiopi(>oZ@X0QpDep;}gcD%f%E~?kn8 z;d0y=KPJdIdpC3$&;QF#hu}2oGsamlX>B4cu-%}kMgE%4d8fJLQY)|*KP*<(Xx;E` za|n)nPC=EW*|@sTiqGUm*9=!;@W$!BV%#SV8`*&}a{$fmp^qxC57(bjSe{S8(Pv;K04N1%C*5&-M;P&Ye-Rc-0 zo=x)dzIes>`mcPWN11g-eZQsWhumhp`U+!+Z=%FHB}>`2)YZ9jNbJtBpYW7HuthK5 zUM9=T**Y0BP$%OLB+0$wsS?JY*P!Rbj4~-=tV#{WLV8NEPTjMsPFjbiNJeeFxO^~3 z)>@rB*_SE@rt4*Vev()oCd>CZ2jwj53LPrD zBk3t?3!Fpue^TP)6Ez~rQ7eFq<9DqZ``6Gv8Y;9LMx93fZo*X7Aj+#?e?pD3TikKr zxe9~JdEh}aYCT4)(X&vET6_7rWDm@q%)jeRPr}h^B=>X2fCsFLzfxg7-}Ax?dRE8t z7z-Gy$WX3Phrc+nbuM)pUxs4;WDUB#=I=k#udurY6IU@d4`kklb8@X=1~j{=$Cea5`|PRpdyVTF z)|yvt&|{~L_2muJ0ANkJ_#^ci^?KH>b!bsY9Yz-eTE5XEi+Q6*jp$<$Wx%e1dZf28 zpu=v)fZsY8nYXCfm~3QSdKEg---55-#P=I;nw(=l15C&Dxap(E+p6?v+MSECoR5cg z&IV5$t)_8q?wt!O>nFi)v$5(kWB2}S6m6%Mpi>U&ouyQL3xuO-pM)sXe zn8V*<%_e(bLf1a@qJD2ex-DO`kTnO^iu}vuz+axn^=Kk^JLBr35=E zrMJRGwx=*RJj_YHH};SxUtMKlO;=H;c}RmV)O}o4BHyc9C3pe7-k$RF^b)E5-Xf>S zF8&)&pXfw-^~G7GQY#B}>TGf5w*pSvEHZYzRc^K`k$-9_kSPkpvPbRdmQwCNOXbFE zGLSVCctXv&i5;l>*i?ac)5td-P~d278@!}e+`bs*A`TTxC~KIt-t&DbD6nNw>UKb zD+7Y?&j9Wrz3EfkfqFd5Uvzp$T{!nZq&E)4=eyK;Eb@nIN7k~}1)-$G9~Za>YelAO zse&wITQZP?Sj&CshmBRZmzxxgp53*Ww3Ruiuk7_dOE27S++UZWMjSb)v1Au_e2<3x z3~~ehT5RR(C*RUyrG>qc>8wk04?Vm!wHxiVD9q4e{7W*8b}{S?qEBvJ>OKZ)IbSdz zz}(SUel)4c_u_FL#k1F}Ewz;Rx-;{%$mQPU{v9p;zDW&%Et&LJ$;9#6WUXx2(_f9; z)bmUv?a##34H-z?n293th!dErKfFB?wbH0B=a7ZjQ!=pWIrA?G8Thy<6N`|Am?l}U z9AW*XkbR4q40yO@;_=l?jC)LO@>)84;xaI6J@<~xv#)X?LphtCxdr5}W{|tmlFxcw zfN!O&)!fU6MX1a8#EfGzsFheu-MC=tE({&( zsh{O4aT{D^(snoT=Qt_zkF#VCZ!Ej)n@Z_G8D`r|PN_Lwb~%e~ zcT@4sah2ZGeoR+2l_$-ciS?&iA`iHU`fw9j7~EXSUviUP0ge*#i{53&$P(VNNQ8Z< zXm*hsj<(8;0;^o^bqnJi5q`Qspe6uME@t}7rfE3WjG??S$J2f6_ zkSXT4nZt3leS8e26w@yvA_iG&$w55VV$6At$A>Z4!S`?QG79VOYcb_hCejB}LvcYS z_KnEI?r`P@M`hp*$C0@WJ;5|&dL76ruFu546J!w+GWi~v$owM{FN?@B-eX_Kt&q#bH-+xTjjUE1#fuZ_bGo71k?nT^iRb{peIl`|fGJJPuN z$Z6y9>3+u1)~Uwwvo*%n^nJ{@s+UVklBD13BpLjXd6(y@lERwNoSyVMqZjla7M-}z z3)0>vRm!lZIT<^mEP!N%RI(_^eRN-*B-z(g@a8^wLAn~hhN&>T zhZ436$P##YV3(g7QHSZ@HPHiyQk1A)q{hHj?oh-kabUCxS8LMOp$2jJnnfyzN27W`suqrDIci)G>U8}*g&l+@m5Q-@q!r&YcjFJXnsLMUz za6hs!Ey8e{Ye9#iFl?B?bz)7{_=ai_RE4@^ed&L8APm35LScJV1LIw4K2{A!%EmBi zvhg*eG>GAvF+;REd1;rdV+O>QxRx-CDb+o+&!3fGdakLmHA zYs_pL15`5%h3mOn{{2eocC<@nUcdl(t;gQ&28{VL7cE%#%ZJ=?0NR*t*0;D@NC$4(m#|u_&Y{=@3 zU&?tdEEC^3=O|myBbf8aIgb0$t_7I&fc*+zsORDDCKac&6VGt9ge#pSc#cx;d9;(w zR_X}nvj3%~4MtwKLEcJRZ2Hp%wWbFEr2!bZkRF*@_M9Y=p}!h{FRfzGqLk~Lr&@SV zAb&oS^YKe99;_rA$6krf%d+r&Dz%D6(?575nYm%~PbLrd#zZ~DhyvJU+0{|dwtzW?mKfq2(4 z5aE908#@Kz6Jy6muB&>GXH4X|O=4W>8L7q7h)g`S<@|d;6RS998-{0Lm}?eJJt)AC zS_K$?H=ml-`FPFi^k`Z>4mh@wP4wSB749MTB3j9jrfntRw}*6_VS`kq0yg_f#R>(c zKC;E;400-DQJ%i%dUYXvGWj`btv|l|(|7tL**rUHdGDbvnU(izGyTEmZpYC>nYjH| zCh8P1R=mt)-Z={%)9F85A)lIioXfeUDrSF&W6O`w)cc6aL2YDg*Ov0dNi6|Qo6Fc; zt>yZ%Hd3Xr4L&_kAcy@&OMI*n-Om<^wmdJ!_BM^!H#CL44Qc!wOHWg-m8%zP*?Z1w z!)r9TTnt7I)WT&Ic|xuq6?uGKBD3g|K_BiM^8CDaja+zbHs>R74L!lR4m?X%ej{1S zm*zGyA+MzjrVjnA&=xY}aWgroQ&BJ5B26YKkTyVpB?GB5`r9Io3%G|ENLGd%$ow+? z2n_SX<=5mH#|Pp0`0WT!XAc6OnH?j!7WZfG13#YFUO)@-lrD~37f&S9NLEIv&O%ak zYP2;kfMq-x&lP0z9mrQYP%ko;EJ1jxoSsaNPHG|gh0)u2?lJa3Qk$`p2U@>SqBXg% zY)=mqy(5d!N&|b&pPx?Am#7x?iI#8=+-L>T#--9fnDz4l17?RCkb9GCb`Jwy^q`kK zKPvv4gL~XJ#$C+Df!FlNTuKgPm%{rCIfs4JN_u;UT7+8_-Y0i67jZsSZvUeb@3VS2 z_3WVR*>^~uT;qPfSdF?Z+z}X{hG%)Qd*7*xm`>)Ld;jZg*n5~4#{4w*^M&la4o`)u zssS+{=q>V#+;-hm_BfLRFU&!o0&>;obAYzF__QGVe|)fYJeQ&m3hxr?NS&Lg@NTkP z;qAq*2RWw5>0SmINS)#pJM~g4kY3NldPyp)hG~&IBFef$|I!`Ho~dDJ;!gi=4c2Fb zQPYc>zYD{0pmjKoz6{4c&eM)tsfXxK#&aX}BKxGG?>*`@j>zR&lf8e-*iYCu8^5-m`tz!sx$FR%V+90Vl#y!^MCp%p@sRV z)1&juSe<;ioGKx+4D$3S*%)4*smImm-i7f#RSgIFZcOV)E``@~LO>5h3i){FmJ6WdpQ~k1ei|4LQR8^BeSZsl=YijyyNUC>JuQl^^h2A{E~2LKWW6 z$(bBR*xGyQPp<)X-l~7~rfErzQtMN9_9e(ZI z(T>`g_w@96T`5VrA~3%b4jq z@Hijic^#ch8D25FH|k+V;=JRfm%-I zwv>5f_I$=s$2X39*lM(V;Pu<4CWF#)Gfe{qq<@tnps!pZScE3eFJT8%yEfv`Kf<1VB z1M$3+x?dv$kbln)^~U-mhS$TNd6aDjxwrEqXBowwwJS03Db7M-qb$TP&qBXWS$H`& z6T`n`A+s5C6HB=ls>i;7G&9Ct=RM=~XHp9JGhaonWdJyFI^;HTU${av`Vop z*EaUYB;Wskyv|HTfS}B>WYF za&O6iKFosGs4U#&wJ{!NO#POLwd`+;OQ0Wj1IG8s1yH=nM_+e7KeY=G>6(t|N8{=c57WagTCk!|$n{5Zw~=gGfMYplVFFvc#=aQ4BFM|(z{ zSgx_{d{epKpdR{8#*Mq=;ZIY~w|*|YOmombg}Kt3AkC?V&>$^E)OFQ3 z!hHMe2JY-*q9%aS9p~%O-+3qJLSCO+oC}+lq384i_UBIs$J_nvPw?P87(fmA`_x1v z8`rKE`==@}enrvi$3U%ivT>_B^IQgVp58$1LDs7~{A)!=#`td@3hyK`guj;@7F}6` zlDuDR+ARu@`LzeXq@GtTZ);YKIz$c^ZTbWbDe;;H*M}6z;G3 z-VMiyd_5)xGnUq)huU`o#6rJDmEAP08$$ z(Yw^$#=Guz#*OFf5xA<8<~33!im@Vks6iUkJtFJL5N=QKz?d=gms-bKrkgw3-Xxo! zLcQT24aUW5$Vh0=vJT@!9}O;6T7lnV*{{GD@n|piYVWCAFphh#1A0`8%0_7oJ~wHM z?_cRzUM?3U19I^05#z&gg}28fY8~_XBnI=mhA6xbBvPA^UW=^7NqnJBy00K>X-yKt z6c2oE<&LKbZfJ6sIy?XHyjHlw=}0)bt_Vd$oe;P)mfda5emxcaxswc-c-w%%^;6OB zu^yFQkg;e;F7|N_e(^p%9hig3tr)x3(NBqAHzmWkpj6@QK(6skW9mhc&2`~D{69Qn z=*ng?kU8-X=OLKQUiGEf8D!neNUiH6^IHFuFehK^TcX9qhMdp(nW>3wC*}Vtk&on1 z&XVtYH9P~cZOoYJYcJN*?Dry%_Gt@`3$`Ll1KKkp8WRsEkW)0dZiZDmYKNYp2u866VZ;ah{5cK z(a!XHeVvZ}qw`R%hO>C)TI8>@{^&cDI(H4pOOijb-fbu~SW9Se%pcmx+>hpH9x zO%iyziY8b-Vj9YVD5erbpw0S-}ZWaS-3%gwq4nCy^X%lm($_9 zClAU4_2txC>RNUVKzElYg#S#(?Y((8KeMrP$h62x`u5IT9gRCH(y_gP8K3SqmQzw9 zOGf*lM+*7M`5E|U1ohFTHIktGaJnDITgvCP>^9<7lt@_ApLkcZkbjQP4ZZnEJq z`O`PlPrOe4%RU2xEqtzKHNTJ-(`k@T(%is$1 zJ*Q^DWbb+svaeV!clE&rj-&gTtU+uxqkm!paXwxm4XIZ+w=d7XX9gM%CI9%czL+K! zOVJ!Z?CTzd%X>31HkH0IzntV);16ltoOzCHjz>PvqiUHE_pGj5D9e1vSwDKIMPp0l zbc9zlW5tZd(s*W(WRR<^QxFY#nSp-g%~;#IzLblgkI^$;pX4ZXo{@p)4f8NVI@am-&#NZP-|J|CY*w1_5a5K;DhdbEkD?*z{;5ftkOgTXpsTHlUvZ zbwxJ@=b_31J1K2$5l=I9E!R@N(j|l3B>llBG?XXpev6WNroFSGa4azct9gB{pQt0< zsi#?+b*G3(a+IFwh+N8^^b1YoN?x)2{h2zLypO9Erc;C3jPi9HGbUE3Ef?sQozyJ=2YYCd{UHPOIgW0(Y9OKAe#vw4uo>i4 z!-MEcUdN1+q4olLww34jE!Qg=zIW+UA8AHOe-}CIPCZciK2M2{#`!-okg=Vda-_S& znu}$6Q~IHwj)Fbsjrbnq1SgUYeepxiQzvvJdBEsu8EC@sa;|v;8Rhhw8bjn3Ymwt? zkbxUq=ika{CL@Zdqf#;mR8L2wA``x~&Dg;F!X*1&lI2fb-9ynh@GS#3znQU1 z^e*H4u;{L{L}vYz#*Vzsm9@BikUa83>WxyX=HjYi8OV9*ts`rCJ{h>>M6Hi4&7|`F zQaL+~zTvi7gimIUUrkS>9u3$>|67{H_;Kw(-ILr5G;7c6On-Un#X?!g>)E=37I!={ zF#2EKUp|K&vWlecRA0oAKkXBdjy%SleoyS>o7y7%!l^S`KN_z8@Hwwwre#5#+?q?h zHs4Uh)zaZBgCzDH=)dH>LC^03nJA%CoN@FAU%yv}ZaqwB*x7=(Hpw!4j*_*FP)ztp{%EQRn|@GV zY-)-qn1iq0J`9t|6KzXpOGL*WXz@ucN8AIGO7=?>MPVzwE@()CUZuU-NKscFo9V^+=NB4Q?2f6O7}D zDJYC){+WKn_PL4DQ>DVQsml@S$Ll#h8~fR_5gnBzZ+5D&n7+mb(}f*zv-V#-YWELqAWh<3hlok=vhME^NoTM&ZzifK!Sh(km7mb>FVC91G@q-?@ z8%^jqkZbOL$!#@u!=|cX7&e=0;(^)Bp;$5fX1v@^QQ^i^`b7Ka;ltzjHll9hz(iTM zpT5tIp@2b$kIdVeY(SGn)VJb#drHSdNo?qb`}AQqmC>U!YY5kVSs;yLrRyG7 zOs1aQeEz?+@6j)qJZ82gR)%#~;@uYdT{WVL;%_G<5 zMb2>|byT~%;dS$1Y195GAJ63qhTaDY&|r9A8bYYum)jfok-J zJraU}CUS6mo^`xm$qf%kF2}p=vHzd@d-vRgUqM#1X^|*SRp}SoHw@{csW18DA*?A@ zR8hrBr&J|coejhCw>o^{IBmJWidW7_GWQ=PhF=Py=C&T@3fZ`~+Cp8IWEtC!{Oo}c z^xsOo)Z_p8cT>l3eTwL3F(1X}E&mn$;(7duE>^@3N|vdqDtP`3!MW!;_NqU`sJY~+ zhf!aZI}u&^(k{b~?qHM@$${S4FIIA<%9Ww0?#sPf&uk3%%ZkStvGQD_gpTj~xCiH}&eSdSR(St>Oy6*m zD+s--2U=5!9(lo-PHuXup9x(iQm1k~YpO!M+MVRn z1~4ZZ$NLiYzvmgfpMNrL_j+aA(xid$;)X*;`~0QpTPklfrnK&4v>sjPHSqgnujqR3 z(`xmMGHyQD`+TPMTh{~kY}0rAT;b&q)-^q=dZgF*+SR(PF1(O7`|TR97JD9^-~Kwz z_+84UcZ?kEnRju@xzmorjMJ{&cy|(YP*IUfs}1wSDXtRB0F4CC6fM9ld0iTXIqN=Ye?9R|jpZZDic{7>x8Y=XMJMtT=F;S()pA+1v&!R%l zu1bW=Qo+2(1C`IH;q{2UgrbJ3whBke@wJE956Yg|er>6_7_G$ldCV_s)wo`u#+(fv z2(-=R4`iY-dXD&zmgNdv`^Lg*Hg6u8h+|fejhQ4z? zX~UX=nRV<{%%QO#_kMlWh8i&LB+-xXy#f8Y>JjKk-Q`bu6f^IiGs%FRzRW58mv{R{ zUoYk=R1OBbWZtR#F6v{b4anMJ!1#8|v8<+MBjZ|YSMrL3vayHxuQcYM{_}%gI6Iqt zoY~N}XDua*dKJvyjc1Le_&z-XnYXX@lOL=<(Z~yxTI66zUN&Z)&qbe3IdIxfZJv6p zS>MP;w-xjn;qQZ%WaF@bV_ZpJuPo-Z&Ss-s1ih?lXXDd1YC_h`##`q9H$<~)5XYtsdDZ7`5^#&;eH)Nm-4;2Jil zbe45c_V2BjVUbQZ*&ljSfx~5}%lP59oY_($lV>O(^!9T-z`SmdMXr)%Y_y1dYr_<{ z5kbF##jl&PO1Vh zb(OwE96{&3qCgo*tF z&?Ag`3VDH;Z6aIsiM|&*0??f7qeB~dGJYd#wIT@1+6Uludp`u-^TUp1{F?QY2x`;a zOz_9BO92?MpZakPVvyg4bzScB@A$KZ@rL=IWz=GvK|RH;)c5Jm9Qh-9@~zWi3BRA4 z$lN(|HRZNzQRxGDstheO{m4E}rMK-OE$oIf&rjXPkhAoPTEN=%T-MW%#=zNuT6D~B z&y9>huU*`OU7$`7Yb8AzX;GE0FP$92eJ1PL-_sFQl#T=MGw_2s@Pb{L_{Ca9UIH~4 zf--U4jowl-+2`*zKXQs~voNG- zCTf3X9xRieJ7=Otau)u&nu%F|@_78)Xy#~cGS5-Gl`NNuc?9M{@;m3l>AV?V&3U-p zj$XFW%(wGrp@YdLE~KwCbMb9Xu)gh@j{%?ZQTGa2EAH<`oT3-*X)=pP^YPQ0?3C$0 z?VJLbSpS*xFLmU~uohK5AHHpw$DhaF8O^9rjsAtVskd>3tQPmm<9D%Eb(1+DuY6n| zN8N(&Ja%_?@w!Tnvk;Yh+u$yVyOmOAT{8*2kEk|D{MRUBF)F^hA5p`OL$7iKnB6D1nVHL2?ZZY}aGUKdr_FIVzVgL4r z`X!Ro(klPyNewI{KU_(HFMY_U6qQQTP>Zx%sKCG|tN0u*mYm@wa%&8A8r#@1PS~IU zeYQfHvc}X-f$Tl(RlUSxHL}vD&?2wsEwja4!FisZF7&<0JY|)BbrjH8O2w9a+S^L} zFeNDv+8Cje(00&wLewI_T7&@R>&3-|fKtpj~4n{r%b4aL5vfp}rVx**3`(4+ut z`^GW2d?;qDBcHs&AHi1wF!&zpl&iIfjflqepcptg#^4*Dd(S@n`OYYe*&mI9`qV|e zrA1{GYls{>mF;3su}TbT-HL|(0lj-VXpvG7jhsR)R=3uoadI^5m}A~{UW*SGSzr6_ zSY&!?TxR}sx)vwHwMZ_Z=gfE305!}-e~LyC$L~4jdA8Qi#OfpTue-_q$&p!DT8$ct zCo^IBL|+r;+SbfU$1~O{>-8b`dz;Kne~vfuiu!@%fjIsg%2U_Wl`IVNMeQ@P(7>0q zJJvW)aXi%-N9LGg=K*uUJ!g_>;0 zT~*eFS2Qj_MUF2Ef4``XV_Ne{8@+Tp{!Y7NevxL=+C5#bXrI=v)c^ck^zyn9QODTt z(_dbZlVa0uoVHJ2)P9H2b?{?P)qsg!?$eUfew1`E#;+V;9Q`TWsO@^excAmHuX(L2 zrANE2H~usIUDt5kGUH`kZ=>O5<8+t#{~GfzWf-Hw4|-aL+NSUQbD!tf$UoB!&B~=m zS<9!#Xnq)%rO;oxfkFQLN?q+rsnVC4C1VZA@+mV>j%=d7;{H^zQnx#8aIz$_FXgbE zK@M!u$(h^KQi{<@@Kl3rUzRApo9U&Z=AcBpO_h^BlEf_~QO2>x(vlk9Cw&rRlA3Ey ztwC0eOp^5t=vzI(AVp^q;)#@{IJ+ z$WUY4Na}*jq_@~-H5PUAfV!;;Y3r0IeC3Xpz38E}L5=ylRB&CbWKWYjDqmFN(_-p) z-%?}aId_cVerv`d`jZ*eC>qY!zEPvbKK9lOVP9g78dbWJeN?kfr(=DNxgLN1?QHKb zsCtEAL8JyXx#rtkIUHMZHE=%~1}AF>`mui3X$o^x7eW!wwPNKbVVKCeUg;3>iMe4I zYz@Puq0|OpKj+8(8r;81-{=KlxaO?E(8y3sHHYE+UJdG;U>z_e4E6Y$rEX*+D~I9L z5e*U^k(X3*y_l&%swEW0PdaQ&V*lzH9S+Y(MeuC)yFAt7RTj1FcXN&BPHpZ9WKQPN z7xWd^hDY^Kmr`qSkO5DYkWW0PM{BMty(iLFI#!Ruy7W5>G2k56f0ITTQ06;((EcH- zQi=NC_6Dp7A|J{8!)n$fk0(%XihuLeWWeUf1`Ogl)YO7~a&@>?TWvzc$Jt14mW%Bb zb8w35y3O1Jf9KjT!HK#s&binal7sq+T;$Bp#<}opOk@tH-7b1>cF)G&G4v`O%bF`| zW^c*EyzE0Q$6@rE=CPKS@b~sP*vPeK)M5H`I+J~@LPm0BHf;G3S(&fr-<~12@_*`R zy+fVl^7U47HC-uNyw!5Jk5Z;JRZ9Cm$mi`X7RR-vGPAT){7JoFM=i*1!-^!C6oJeMmb@O%4$WpUr zaDnqi?pHI0Q4?{~X8PA}AfHx~y2-~~<;_r6c|O!h{u<{dJKi*tqtroe%~<1~r$FY( zQrUV~fzM-Y(A!%9GyB|Ua{U$AF$jGbS9bgkMAj(sd&$(<+C+Yl>ng%Dxb!bI8c%b5 z)0=Z_pDc9py1<_HEI635;1t01#|wHW_sT~L&S~jacrIKY_%9=aZFT4As-zP8cA^8_ zWSzTO#@^+6mT_@-pHjI~LxHX;1qL~hP3fgT;TCFa?G1p}f&gq^6Np}e>7`sL5R+b0 z8~8r;nz~TuiZMoCH3qY`l85IS3J0?oN3*bD@&yzR%ED$(&fAak(cdi}lE^*^@(xF5 zo1x{L>64_AVev}w{NXBpU2HCUR<#tr4E9z$vqTfxGhFSIGW!xWEZ?`3JE1Nz^lJ-QI@Vq4Py^ln zhXT7!(gQoPMAq0V*o#ij&MJZQ!eLxK9Eb~(0&!B~kNEP`N8?)b@@d9jUoDz0WAA~H z{Qp`lB7SGWK7d|&A>{l6GO^)&Cff1qUK{E8#_RFLKOcMPfgSgdOh_j6uFk2%?V4IX z%xEp4)mzAkDE5prRmp&08|?73!KM8Q>?u^h<(3WR`74m13xH;00PLIs;r=85?mzso zaToiMM#TW(F?e;1JwuG+h9g?OC-u$0(ub>*HNrC zWI;Z{_U1$Jglywwy~I%G4}Vg#_s>)btfrHJJ#-STW{&L+y?N)kqiZ{IV8`gyX;00h za^ZNnHw^Fo4#n!F8Z@}4!P|+{sO7xno@9U*_oMYK>{r&OLeD+y)dkeFYLbIieRFY$ zxT*?z_kuj$- z{{m|t1uEQQ%6~omQ2V2VF#K1IO;P_*C2W<=Tu~D(c@@M z>O@|k-)kK68vJ^8Yw|-M$jmeEkothW)BO6^J;oNE&txBRjByI@XXH?8wq;IntHS%T zf!d6@VJ2+ualy80U_~`|0t)8q(RGDr)3=pkN0XJwEd`s#b!IcpQ4{~ z68#1^7yiiP8rm}p1IlLM#{PW7P2#%t7kNF-iD#?Or}sN`uw2{9=dDVKxTuz6R@cj%do~21CFjH_Z|c}r3qXl4nYbVH zzxJYz?)wD>|U~8k*s-2 zX(nn^EI_xvc^>De!_4c{dK|qHF6Kiso%)A8JY+PP!HtZm~tZ&AxzZ>!jm^&CFl z2FtIONYHxjSGgBGScbf5sXuzU(gS-6YrxaV5jt_rF+Bz+xz^bKjXi0#wqr=27_{#Y z!`yf#+^+K@g8rg8?CYvTkB0*05|%MmBr-l!rY}Rk0yvb=n^Kz(=L4>sDci}^`f8c< z+*x|^o~^sjeqO5$){Q3fey&tbIN4x3S)ivg6j(Sf0GW#dal2&z)U5-s%AbDNO@dIa zQw;uKO!pZ>U4Hhnjlaa+H$FeB*mpLH=g~*Q+=(~isUi#W=Vak0a|{W8=A#DpOZ|KE zqb>JdyQoj?*<5=2HkB*yxZWU#@1=8<%A;Il17m24qgCE8rrwYGE#pSm!rY(z0{(n{ zI+FF&aXr?Yxhrz0%bkZ(LyP&GZCch|>GKg3jW#^D=vFcK_aWnGXX<40nv6=w1i0Sl z;?4LzgSBwRtA^#NNqw*Y)jqPfV}TjgE(V#~G+BO{ljPjo6#1>vNnv?K?!{>sJHyVS1b_;=i+@IKABmBq0hyIU3QhBTz1H9ewim|lgH+Q6+W9*70>%E8hX2#El39Qq7(opA2!&t4M zb{e&N&(p7uIo=*Tuf-mzNatMr;TY#YSDpv+w6Tu47!yj3bLLuak)8g;Iq*%O!rPJa z;%w^vMJa5&Te2_Bq@mWqQZn89Qe@?7>h51P$i=VB&rea)-&KtO&V#*_9ym5zjcZ4F z4ld#Jk)(dlGRCstFpM6lK`XCRY#UAApBkx{vz$7*8&lDVabrz$vhQT|ex9L@<$zqM z?_{H%F$Y8MDZKlnQLmN^V`>I98hM?*y0Gs5jr+~v^pdi$j(48iU^?&DPxdSr+;MD$ z2Tr!5j{ihA1nyU1>IoHoZ_r>wk1)i|<~h|2=bnMRXMbyOx&!@=V(Dwtidx5y3~(e* zSdG`G+{&vmWbdL8ZUEysrg`f8-y#HqW*x5+o-D1%}35!20 zi)QKMnSY9$4@r?b)Q=q4llsP6-SN%jjvN;iHm9kvZKgZ^zNo>TkL+z@481p)8V5r5 zls^l;&v-G5bu1g^;0IF2fO&rhXT~wEH|k8x##;7tct*3Q-%1^T4ea}OBRd#MAG*ct zqnM}g{+>x~l={?*^w5jLyHu%t@u1ASM4jwgdO80^Cw+IQaig<4?Cz>@u?%&fr*nUM z%LDVz^IQ%vW{o2c%h(mdz2*q+ZC}5lUN-lR14im`+p0&;AoiOKpk~5GEC1sQmR@aTuY>0rY}xjh^DrBI+;T= zj#F20^5)+%Vjg|5g&M`xGax(7Xb|fl3FL9Qk+WO1nDg1=479IpMu&!u(lWP5Y_9v^ zmYRH`A_I$(KHzJgdZI1-EiUBU`oxo;Iz*kj$$1#sklf;=B3b3)i->?|thO-M*4T_& zzKtZ?u0&o{^2Ot{D7>1N0qwOs?6YYsr#G_pu$2AP)5xPO%EZk8a!(O<((wCt+4Pq$ zHG`uO!Jd5EKh5-@X(&0Je#$oS!+UabjWp@l+tCcwb_ZFc{KfT>9~_yhw`8Sb*R4D} z>rhWT>2rOWI&P!aGdHQ^{nF;)@1O=!pV!UtiVxnOkH(3I)D0~D0K=gAk~ra)1lRY$ zt6(i|Fpu}|aQYf|vXg3~e@G>zAD;32oyfx;BWEl$n zsvY{EyDyuMg?C!d&{Q zQH^9|_Yyg@b_nkL8HElzGoen&gU5^}((6g7+-2Uk|CMOiNG2ww=i$xz`l2pxl^Lv~ z{Kq*~2+zO<9{=WYpy%sX41afVQ!l;k&S2X_U!uy+I#y4JGMfsZ6Wv z4^L|p7Trk4)?wr~-`0}^^KZHG!4L25P`{7kw@FPimL7K!FRoFt5BXv@`QlA()cfQ8 zofO(cEaAnn@zf9$^@_&g@$}I8od;WKD1VnJkx|q|y*)M>O*W?E*o{2aRUKpy`L%UV zsE^r*S{bG3$R0)i`qTDe7)(F(5!7{!V_!cx)6tXp{HUE|b8L~cm`q;pZZy51=r2#6 z@zw77vStK%$v1u&!|^rPEdvFYdB4Uqlxo!R{O7I@8dfG}dNBhw_S`e?c9d;1=o`M& z2iaAagJ+I=d?Dwz6nn|o_d_~N^o7&eD2(dG9032{KXV(%a^-K?N8V)4)-7K z`yX_xFU8st*)qi!>z8U_-#rr^pYx#CG?Ji(#o}S-kEhFcKI_Txk?*$Y(|~&Jh0-Q) zFy>TZZA>z7Ix`Q=$~BSc^M7)T`QmivX!`DEU{@tG=KgFbc~zc`O5yrjR4Pq!hbN#WJzTANCcaal?aNXI-g{!RP-0^;NPK zkvndxMZu+XxbQsJsF>?&QY;JMiwUi$qfm={WkuGUERCd^k@=JRKJXz&*?R?_|Al6} zwrwhpzL&__*F&JAZsV%S^pCE zHf%+Uj@v*hP9BSw0CIe@JVKGv zSBJoMCj2>)y($~Xou#SpmV3f;O8O%Hdj>1PsxVOw;_dO*IZrWMM% z^id5_;!G-a{i^C7BoCqh6Nj|Q2OZv|?%SQdXRy4nmDD@jE@jjD&&Cxm( zZzq@3)Pg^m&zMdAZr;aWL^mN%dN&(20-5V*L%qvkF8CH12K9A%54AL*w=H>}V|zsB ztb+T&V3cd2L;gVeG7EXAGx1{c%M}5;$)Aqb0$VHsvfiF zQ%A1{b^4k@lf}b9i4U`a(eWVpufF6pxJKRAm0lcE z-Pqer?(BdLN9D}F3LYWpqK9>IJ*Rt`rA@$C6iL(C(Ih>=xxWu|fpM56y zU9`X{JxK~otOL>GblyW9PINZm3c0O8r;@}jPl@(Q4X)MIBYpuauwo=@cF3h7@=o_ED<`jx-X!E;bHqS$jYrCXw$awFf$ap6Ob)j5*6nK@SW z^^l{qy5d$ha&tjCbY1fhopQ;yPEC*j=jaRX90vPePQ?u|bHcFs1NA_Q=vzIKIm3@} z@?;hLj*~+%pPXaX=ZEy|qOM=Pcsa6AjgIm3%U(r2M2r ztybjbvMgv`6fcLU$J%oOeXDuh4C750@t!}Qo+y>3sBnwE$y>gX^L=eXEcFCkFT}~| zWO9^qm!k`FdsX>7*W`ZUkJse&e!8Is^+Q9dvfpbxePBGT)bEIsw3TjnwK@dT9CEY-I;HZ zdz0g+_Fif0ufmtrp)mWB3w~w7c#w*BrBK?+-gO^cAcbBkM(6r zDE!*8_Ep6M*Dx!4sS@M`{oI<=4@Jk8df0w8!GYJ|^QdIG_R$sdJh?xjPU1Mu|NS_A zPbb95%F5JpoECzse^bwtM0VkN)p(Em&76 zSqc}b@U3V$+B+EFbd2%hHGSS)lI1G7@7f$+q0B=hd1RyRzW+VX7(C)lT56cZSpL8R z&rAEAyQV!)G>&QKpSJYILr;&dM?Keni|E?gUhn0$x{TL9F^$vfS6yLL-};*Nhihuu zgTqQ=`>d(P37=M`y*fF~%jWJa&yPnxbq2 zWWU$ot=Eld^&*XXWv)03Ujx7F0im3anf`t-2Wm}wAI zo=zgwsd8?IL3X?9WJ<$>Qmz60{`%}_d`;QgOZh$Do+c@Ascn_t}Aoo`3C8*nqTLoNbKnp*-MR|4CfU2L@$OV zH+f9{?TxGMn8f*R{sDI!q26nydh`n1L*1NR?yM`jM!!^syE%y zyPO9a-C-=|I^$onI~mXqp!l^S!AFXQP2qXikXMSMNM0%6l3q@*w z)@_&v>(n>|{~u{*9n|K#wd(}x?gmuw1gU#z*G=6iUUzp_Ak^KEx?@RzQrAGJyCQWr z0@O=^0y+2I-+Xgs&cA2RbSfLd`%7MVp0%!Z-4WF^_!mr;opl6%*1cB-hGPC9I-SYw z|LMaz{Td#Jl?LaJ>5+7X^9hUSQsncaiJKnwfn*u&;xTO>>q0AZ*cQwF@}_u1JFs3g zC?1uz=}^y~{b_zrw}$M!tkH8OMUPXfba;G0i|AcC%wtXc$vs~0tMt%aWX+;8``kME z8F`Oy&6-^OemV@fL!S7l4sVa@P^B_^;_*5hwr9<~BpsHV4UH;hHX!R7iL8xnxXjwz z6J`p2Wi}w|8`*v7%W)#-_%Izq26BFr_rEqfm}kQOudifcS4+-4uuX*FZ8g8ej1hz%b*vCbrZfuferInW|Ds#$66qJ61pB_AA38=_3O?O z@|c-@cFkn@Sw~51?I5rFxXK=Dy66qfBzc{S?3ztKkHJYOD3Uk)`}yIna&k8JqFtQD z@iAwBraQ}qNsdy-zp-{y4(EMhC9_?Z^9K z)`$QM9Khbf0QNlA`ynRF2R$_O$K3YA(}O-(H-s*iVqffk7YNljf6TV_qpO48f5IE) z1Dp?K-T%>K&Jo`5$GOey`R@vVbw6MHU~OiORRBiRpcf*=A2a6qp^@GP`E_jx6j*flsiI> z>M1!Z*9dH_8o^$3Bo4CPFfxYTIb8%&l34E_6oF=(RSauM?vcNo?}nrD5B{uKTa@&Wmy{^ zMZU2Qod{!@f3=Pdf>+Et(9_$#EEq!<#0EMTH@iv40V+B9!&$tpw~+&CcUdvXU8)YY6Q>C(*;3I#E(~#(iu5oJ zd21(~R+Ax~(M+6bs-)a+H|fP(i3a@ImXF9Nk~!&AMTuwgi)9ZP#`S6oH0;2PwQuxX zv{J&>g}ejVlm(7TjHYjKwzF9dyYRZGY!+uaD7M!ukz-$rMf;On#%Tq%@*35TQlM0h z5>0v(%g5?`?d!~tEU!eDuOPx-x>4}Gv|f-iR5 z@WJ8M^q#z>|B(#hd9sHImXUax7>-dXgn zftz?AQePd?Qg_H%pLtPxbOWFxhdaNXL z*U5lvtvvpdAhXzGx}T_(-={be!|$6-xA*wc3G(}Byj-)>O2}6-kJS?7<2EvrR}2M?^D0-Az2yS8LF5m> z?8^RhbpKM}elInSmvDxSzw#cc*)Mg)wJV&R;?KM^gxDg4Z)^M^mu>QAZ@k=nt}9i|6+aNmIm27G-w#gnZy8ktPX@AZvp)zW$4%9KIlzb z&aw37oJzq zJ!142md*LSJgx=LaqUMp$*A+35B^X8?2--I#~YG;~T#=s-7O@*kkkO zYu`Gh$KW4Y6m4Xd-gxFFbYeCM>kftdo(CiJNF?8bM|7z*&cJ@oyEI##0sC{zV&Gcv zp_-0H5ANHV(k;UE;OkH6>}`|fV9)T{an8H4-@9l<23nKLnMKA!*)0=SxHj}O{*P~L zNDga7F|4<64eClyc_ zINclJD%Wo|m40Jd%B(5PW%48iG9Pih^_)47FS#z;roiAs3iv$=QAI3Ec2&tILaa`GW#>_<=S(1snp+DE|qnYIppNGuH%}K&$kEN$vSLj zUgiuX>Mrud*%f|x)7}pXvKKe`Y}j3gF74!Sv^*Y(m?S!=hekr*FcN{anDac(hzjM5 zIQNhBdh!KviM;22G9qXx{m#5sRqn_2LQfNp+{(d%EjgHUhyLSewS?_!CXS`rN!8S5 zGV_{R=6fmeGgE;yDW6pZ^nNwh`{9(yADuQwAm|C} z_@5#XIfu`h&h-3}3-PROM3v1(lw`}%1s>BT3wRk6XqRo4?>!ZmUfmxL_t8JD z;LJ|4FAiSuLuzj_Gxj_1YiuMg@VWME3^|@=WG#E~eJV8x@QZDUs%4_E2-!CodDRm*42S9F`D!1CP+ zuB}RBat*U=)G1N_fl_U(RMDVJL?|;+xaYNIue>6excYh=t-^h4AMRs$Z@OuhiBqioPF&Bra3lH| z$r~u&ai8f-9xg-SX~ml4NPF^nhxz9$h3DUxSlRzVD{Xhg$;T>m2~X8YeihD74pSqj zuPfw@8~${6MO0@shL)&NrXO>Ax`pE8;t=e9u7R^t2v!^+WBFQ#^$oe-UaUjzIQnNN zk$rfmM`snYfuA#Dx(pqNkLjK5#(ivT1|E-6cqZ*oc-CVNLUlpmY44@<sz)l@AtA3=zhx_w8YctXH7CDUW%nJRW z@LWLG--Omm&jDt#gA)~=w-s91+crsB>`RnepXu8QijgUu;^k5xYtLzFj1Ojp=@(br z;d9lW@6TFa4HA}-OBtkrg9~dIe2@N)4@KkIe9p{d4tH}hdkOKV*p#dc8J^9NY52)! zfeqi66Hz>lR?IX_WQ~CDNj$kq+it8O+bccKB#_nnt?+DAStpm`6Q!=RUe3}3_Gg1m z9_`jiu$n$JTUQ)?szMV>7YupiioX+>zj2s8D+djBC25c`A{2xAg+gl=j20pEZB^i0 ze;n%_ZaR2`>QS+FJX-!HYmvj*Zq^xm&d?FOlXZ;h88FZ0xx)Hihh7TLCY$MMtVOpc zKfgQ74V^tPLFiYLU+3b5E&@rPnIuKNYFyc?#*^kee@2kcJ*Gx{ea=;MrynwkYlFS? zF6T4fV|XZ^C84N4MTc6$^r%`s9$8n&6(#GKAsmkr_H+~1BfI05iECfdk=`l;W8Kqv z|519b_)OpE9W$msA%S*U;pw|k;kh@)R+cJVrDhuEH`}QsWJEKudC*iw>q;b=^@Z&N zEs)<ON-jKZCYcG% z#ev@A2Y;O9&qh0m=W#fcvczfDIXY~%K-M57{J$vRrSON<9X}l6{%8b`=f*vMxOJpo zp8J%yd}gJ@Mxp}u_;!yY;Klo6f|Zdx5%=F**H7oOb$K7|33&fG%4fvv_2dO+kfScg zS)rlyBPNjbW@bR?!7Zd~VLN&H!%coY<~=&bRdS4+>-4l_evk!oQn_byR3LjyiRi2Y zFm19wRvq<6JbSV2N7D7zCII!g7s?2v!?HK`H!mYl`7q}p8%N^ReeUOn(&1Z)&f3!S z3fo`8#xkjNJ>>wWv!UdA-o$79GOHZS4o4DR;B6Xcy<>&f3K4j9(f65;l`F?#3@JGd`k^JwBL}MS$kFiz~ zmJ!LmI-mFbQV{J(2mS0+9O63TRe+KAEixSMc`W4KkKHk0-^wx5sZeb0*yTogj-t=JWh{ z?tS>2IO0uTBed;rK1|Mrqjs4#2GR4 zZwd+%c<%6d-=r<)JqNHa&GRQPg`QEK&y&6A)x4z>Uz1LnI_c$;N-x8#5+zC>FXuX{ zP@cZ_XLHo(mQB8UIeQ0Z)HqR#KHs|D8{xfq z%SRo&xTc=jFauQ;anF%!(?P7Cu2y(9B)?dj&y7DJ&*etI+;9sl2)9wYC6L9DBmyTHCkV?IZ_b8Wsl6Vu0%i`&C{ zAz8G~!xf%m_-y?|KhV3Z1Q|wmeqL&#G#L>uhYHyT7?~(tpSWR4mOFlKbcOXFSIn7D z$M94a=r=N}XoCj1%23{~Ll9>l3cFDH=UGplvp|Q=tZBy|(P5(K(RU&1)I6TmtPNl7 z!}q8ZeZDCf=s%yC*ksGAsFa>tc9XHBFY>CD(zE_4GN7y2uee2quup=x-DWm;CH76L zCrN+y3Y>Lrn5lHbfCRb{>|J0y?SiLf4GJSPIBB85+WLHte$sO>QN#N<=ekDfu|I_@ z;|V=Zc8h056J3P9oVkj~Kqwi{r*$&m$Mwfvt~rjrpwolLVeGH;Y{&cb@#%EvJXLr; zoX4Dk%s9FBAYL5kYB0{!i{-UM>A%_)o9DWq9(m7)N>{X6#g zzVsb)e&cOCT#+i5?jmv;;ALq-Cu=gK94u2tgvgzzkyYtxo{9m52<_RlF$o(tBpK;#( zaTrdXOh#=t6IKtXFK+1ta*}&2|NL;?Us5postGc#iOinEoRk}bQ1?A^K$vGbzbSJs zYT0nMiS_ZG^bDS+r_3z{>zbI5;8{lwcP^9At zBN|Iz&qA4W+6QCwtc|rGFTF7fi>Fvi;jo_@YJZY>SR0*@5*e8U>@^?DM0ut>h` z@WzngtoJ=j!He4DhBjGAN!fe})-ca^b~yAttZo0!LLKstBaOesnmIC)Duv^0=@fMA zkcIwD8b~!V=8H7m=rJV>woO^DV|{vD4I8<%;IGKaLFn3zu7FBLDE+f=sHm=#ZShxD z_4S5+J3WSjQkVrzUQE|OtnL4b|Jy;B+c*q(!S_FwJYaGYXdAk!)bUB#7R(+ zo)@+Zq-XF@3LYnsYrEf2vOg5b;r8Bm7e-Ev|K5H#^Qj$e^omjgINc+$o+-wWhRwrJ9e-(`G&{o-NIUyoGp}#2feYD`QQ)u%+A=v z^Fi4_jEz{!Zp%!c(_v_xk%B9~==Z!~E4?{mu$^^?PvK#BpOy@_?k1$UGH;!;{Mnbi zaeP)7qL(qBx10%4rmjS%Gb%^ z=f16hsmrkW4-@pEi(Ck3VAOvsziNS^%4lPRm{vn$U&3OP6nevXdM8_4Bp`OeZ5_?+T?(Gat-r8;(=4^nEWep~vrrGTWy}My?}AIW3GHtQ0Id zX+n#!wZ)elYtbljh2xo-@FWEbJDX55sGd|h!W`jxzOXnDhC4hT*4@qma_h?KN=4Fi zurFTmd~RBhf&iZ9s(Q7h^VGjmVH$I~N066HV7@TdtD*gCNx;N>Io5$W;MU{^)%3JZ z%fd8wJ5inaBiWpHtUNv(Z`rF!2d``A2BKO2SE9)^yUwS#^m7VYzBXZONj(`tUbtl^ zA95vODCYU2>TiN`^?IU+E0A`he6Xx>I5M46P`-2)JRdZY!T0m!-WzY|5}1(`%zUqc zEL`c*K%RXokxCQ1@mEQ&=;{>I=h{e5uCr(0Ux{Nr`&s{RST!Wy9hikP;r4QS?O&-$ zZ}%o%M_pOVxiCKqV`ke({+B%QWlnd_D!z_W3KIGCHDA_~kd_5f|B^RO_X$Iv3(4%8 zXQ7w6v5fclC%qex16>)8`s71P^L>8P&Q^wa7fRV4zIaiFyz`i3bem|x_J(x2a6j=X z&Kv(&`|sdOZ)xu=%skgbEcAu)GRX(YKg03-Z8D;VlUsaOUk(~dWCVFY&FXLj@H`1` zn2j~Z8_VY!3REBmts*yit_JzjYhUo|4|&^cW@BCTL0-mo6TO_KVtM=4 z8wdC~zUBR@%YNoZziA*%$sJFxM?Ud(7}iE4W86pPp_jIj8R~zs&CUmX74$GprdMQw z3BFtENEZF48RTA9z6i(f`Sd0nBp*7Xp3Jr|ix=<12RD=B9+iSY08VV z#!S5yJN0QuBGU8(dcm)D`?hcvXAWk#jK{ZjL(BN{m`Lywa>tjtTt@Ot!}B^{CV5h_G( z3dRPV7K#P*pj9lv{RIc42lQH-A8Xi6~BV+OrxvrGi6jQeSEc*H*bW_rz9sG_9*2IfjP zVMZl6oh<%bw^rQSRyr)|rB0~)Ybl18VNIh-I_p&AgUDO;b5vpKUe;wsYO(tddBd9} z2rND<&zaBLg1H{Gb}|=&Tw(L(W~gyUg!#^Wmo7sizR&Rw)3AnoQ*U#u#Me<_9rL@b z8fa1LHFI50nej`-{M1bInfqAu=hfxx~ow?!ka!%UR)c!JZ{Jy#PJYlw#T8cc^bU0(L=YJ zpVtj%cx@qfHiN#)_GySa&GYJEoVeasAuy1>xrWT@WQ|-~&5YqIweo?i%ZSWi&Tnb4 zp$d6YORk+;AC^ip)cCtTh`HBV+_&YdDPOS=zFGKkq^s$aghdX(_TAL2Z^7l?yVdlS=Vjj0H9j~gI;afFI_B38=ep)Ok zlZFyc&WqEV*}c6A?KTJF%4G71ypGZq@cIosBBpvO)ZV%bJJPkR)jmd}V%Hi zN4yRpuS(AGRv&sTb9f&c7c2U8Ds17uU+Kfw&wY#;{QB>WqvdE-CusgGL;DqRsNI-c z>Hsr5Umg-O{hM~=E_K_;vrkWl?+RK6r`&<1md>v5P!%!;j!b=xz$9ZE`C5KtoOjbq>_So=Zm0{wQ=LYMu z!wp*#U6Ma5@(r<-)P{pTRXzT6wDj1SQr^S%-zvje)dNG{%BGHgUt1(MUv{(8wM@(8 zsiy~c#93XsILu8iDMbnL!G<&NxAaooS|=+)nXmC$Cl&U@OXcM{dAK4@PUPz8p-PZy zUOL&VkCt_!mD6Uu)My?nt3Jd_kLK~xZ4>v)H}taZZmcZ0q?6B~dTDnkR+=y)BfpGR zCY+9!v6J-DDv<0pVx|M8TK~-ND zcr>6Mp-_)%WrVU3f7nAYF+SYrwh(=e|~tD3o7zHJ7a7^5(0N&R%&=57r!( zGuw~7<~Z)_OGAUP`K)4qXYJ6NeV(0qlpVx6&=F<2 zawZn@@2gqsdu@@)nJn^(>}&V;WZmX;1}+6K+u{K4=j>0PIL5!v;_Pf_IzES|V`$5! zl0Vl~MsI5_OPB#C|LjCjM=hi8sl@0yRRPueltHc-DN-kNefZYn5-d!xFehOUQQYA>Sno^s=x_1C9GetCjY}M{-qQc zzo|%C^*2k&_kZ%KLb0@}rhp~)NtZ$t2>N6eMVTV8IHJV7HA~^3D$% zdicTmYXHI=>5h5zpB{Yx4yOe`9q12ty+2yJ`(f}AUtC@4507sF=#=b_@t^!r;O~d1 z{{ArC@YxpY-@Wz)ZG{X|A+|G+!ldN-0zL%-gHY-x*Gq{&p0^(`>M0o{4xUb4+I;x79-NvwnC zu|}VKi>#D^_3(PB2)8%l))*t2&R{Ms8LXz4=#N`NW??LS4KGvC*`D0MT=G+kQ&CBk zipu=|wt?Ozn^dS*(%m?Yj<{1P7^$N(?k}^m8mA(kuVL_Kmi2bB2gg#-wmEx7J~{Nf z(W#i4je-1og>qRCi)_4_X+peHHg;6WM!9UxymmCfr)M_acFD#GPtL4;WhUWMGFRJK zZ;H*vy6>E49hHNj^O$kDDH|@ev$381@SWrZ&aTTr(h}xLKgq_W&2(?vpciRxHafB= zvxjxEMxEGm$jHXeN-CLLsFt1297XG(l5zWOnQQ1I!wvM7?qtoz-9dWYv6rKZ++^`u z2kCj!Nv0ig6xr-7TMOLeXhvf?7+oZ;u8R!m;3{)6U8Ve97pd0FQRa%DS5->P?ph)r>M9WZRe|0a z7C6dly#6ThY6jg}qC~K_0vmG`s7-(AjK<`C1I!Y;rdT|Km1yy$M6|V(*nUch zl&j<%&1RYHRU!e+OXU9je{y+63A2Lesu)lrX9g6@xT<87jS3_kE0Sgd6;QubVr*+> zg3{SoX@x%;&GW-$dQVO9%(=Y99J5M(m|7zMJ8Jl$M|ozLvDTH@+#kwT^lelnV==@Z z_DKOqeNSeQ*IgXHZ($!_*v9z5{X_tKK62*psxJlv`YWgt@_-`t@9AEe&#}(7BsE>rxSaQVtvyE*e z9>#>D)uRaf=}b1bJ~_uB^fFD2L8z2Mgj`}g9agm?k?qHPcdH%fJtQ0kGug#q z{Jy*}Jg>?b*|}tjKhVcDJ(9Cm%xGK3*XHjD#o@3BVJ7v_aJ1QD#2fbgCXS)s^a1;& zb9mkKBq!0B*O-B{e9aaejmWU3TT79O#z*=8&*61gGnMN*BO2!M8cQ@{;lWhQxoboR)(q#(GvW(> ze`g|7#Qs`Q&1|H$%E5#Lp68*g0|qmfeMC0qlNs4Ghu4yAHnxo7{BLg)GRYy1c}EVh zCEbe`v+%l74!jqTcS$nAYg9HG@_W5*kn2b%+xVQUaf=)*`jU+s{CfcTn7;pVkj<|P z$)OLjZZ_tvWZlS@{m%%HR8SG0&(r_}G+BR({YJcFOPz?^@M0Sh#ga{(a)KVUsa2VieZvPyp)=%mElFP@{?=9`oVg+H%l+u_cH%EjQ)wwak9}*Cv(rm$ zv8s^BIox9s<{2k*Iq%ZuE!T{nVx-Z(I7xBTi(`!hN&d+7BD1ebmT1K@H%9z!>R7u? zlsO~mW#lZ)ovZAPS!!kde62ifuaof(39{W%Cvek=vM#eOYjQofRt?|wE|~Ixy}TqB z1Z{Fb6K6Mc^r!EFJ+zA+WI|H8CLFIqZ>|Ab&7ni(sEW*u3##qr+HZpzI~us+K>&S9 zpV?m;@64=P6^1#h&@xOsIhznXJ%4V__~6bb6ktwTjYYY zVe}@FSxBf9g0e{(G=3j~g*Q0g(m;c}ln`uF)7kP=gBAR`Z{>1Pe-Lmzlku0OeUEav)h)jT@E?a9|{BfH|40aaiIYLYdq^eY{U3(^q8 zwc2v72YYr+M*-J@?;O*S(>?>nUYtv5nt{g4$tdklr#p=GuihEx_J-MIBRLbpzVGN- z{GFb!zfN?xkW)PBnu!CYGcj}``H!cp1v5v-df^vRnn~voe?~y@wF^b5NwuvoRLX>O-AmiFD6*{Le)6{2{!_eKZbtc3%+Q< z=g-+2^z$}jCZ@{{wx0q|M>P8&odML3rM? za{ry3Y;Mp}G+aknY_^sCMG9v0l*nf~z^vPuW$s`F?$=dfQ#JBK(e$;=;GD&k0Q}h& zfJwXj(RFqNHn=l$`W%^=nUQeKjD(jL^QPCP!orK|)BCBou`m_evuKq5%J~9+GW>gU zkn54d*|!|lhIlSF&B2GcNfOXAUaVFnl9SQPp?i8sUKlSsuBp*_mpc|#XC~$c71BGn zq5=2&k>ly3)rX?+FZaHI8r&YM0p@6M>LvM$Ejk<=$a|ME9yiXA#o#^3_ES1$f9Gsl z5%-;DX3ccSL^AIS`$zMDis`RWwH&O!=GbglkB5r5R!#-Z> zRMg2rgBmLbF(WgB9w#2#2tFtB_q*aX^F6$yLa^*BS&)~Zxbc8|dN_SfE4k0!uEQ87 zW;*ZUJ&${5LrdlrY+$~?R{COjkGgD`i91Od%zq}E&D=-aPiaC}89^8Bm2{l0 zn2GTYN>3|yrRSlkNrT=CGv z8PT_{(64pFbw^iJT;z(JJhCbE$?NesR*TQB7onk;P-i*Db>l4LbUl*8br{)`PG7Ph zAHDSSosm&rLWhI{@9}-f%Y^ct-Zc})$%3pr#XQqkg=fk*g=ddU@~0;Ht*XUK{AHck zjv=SAHBsiRh?n}z$Xr><70u`;ux~;?^I~Rj+*f1kWHknC*PvzDP^^xjHY|Ykg*JNRC=~hlEvrzSkP!ksU7MdrzWcu&xi8O?nNUBh#C&=q@$xe6ya$HzT*@ojp1 zE7Fa)hkNa)2pmi2-gN<)G|m}~j@U6gEuG;>1v|tD- zZ45wEJ04Sj4<0V$J+OfL^p%mU=|-@=Mi=~8@^USVcw3u(z1w`Q?oP$XAx3QdoPw*) zIe6VG2P3=WpuvM2G<3{`GuQLm46b5q?Ji?Ry2*sf&7^FSyV!hfCYze_nI2y( z?TQj3S8-oAPl?YJ{7|7<0Ls4bL-nu#v|Hte1JC{N*e-(mD$Y&TC*#Sw!J__=7^sNE zVguPu?%zA@;|vz}^Z3WTgqpk_*ZZgV9No>ma%avpW&7k}A@|suSGY*qip|8z+gVEa zI*FmMsXUBxl8s&YUQ{y6_znvEVA$`f4d%cXnVm>b_4Twa|%4FVmq#`?xb7IfAml~alf@?-ZS~G*eCI=Ham-W0w zHl{Dg#gR5S*g@trHpoHjtz0GWv09$}a+Mg?z`C8~IpaVcwVd;q^q%*vuj113suwY|0DvZUqs*<_j-dhMkKH2XS6C6Z~ic& zlMZH_OvUxXWM6ZchnUa#u)4W;Xvul8pV{;$xk+9{cR8NpBvbR9rIoIkOz-R>%g0)v z+CR>7@cF*dS4lUf5^r-$q-HU_PcQvZi_g_W1!r;LkF)Fjklvr4R|IED?7046{io}& z9SB|)iTh5S}>3OD|2kMG&IbtngAJaf?a4L!`9;hbJMQQ94( zt2SRRgMH)4Pmy7s!@TJ%7i0yvq3k$UXt#2{K0=KO-^ep2Xi%>U=hL6@xxu-j($je# znxNsVln$3WlVAM9b#)D{$=k&LcYW?MDif|Z)9FXb!1u3YzmAecd(S*$a@`;5DLh}+ zR(h_TtnfTXpYBoejBke@lRs|~CFRml`Qgqw`i}&;K)zDK)fjct4gY4Uv3Qj$c3QY% z{b(mNvcLqjI z;Y`r%4BXG9-J^^P$m$KCBeqLr@`L2{j&|W}z$Be$dXd?C5+@GlV&!xh z&Ma)B`*1YxgGoFV*5}9Cs!`nD6^5a~xMQQiyZOv6_Sc{dpQmsAf-#S*d#3~Req7R{ zm5(0Tig@%^=$U($jzAt$6RzW{*UH3_A|BgqW-BkD+nCR<*$3&Yg9_E9WIVV7_ab+3iPFFc9P04$1@QRm>i*#~h8)rMnd*-cj!F4|u{JrNw4nc+Y z`{>p*xc=9@e<*-i)1KTDmSxUUP$-`D2t~;qJuXgQ|J6dL9ZN9>D5q-yJ_mdyw^F5yP6L-nR&fUd6PMKHOgdd$Q=sKMk&x*3Bt=v<3lg$<#Y#I?t}o%DN7 z*5fhf147nv-NDc8(sw;JEX}}x(iw2sL-)WU=5g~gE15}mKKafTDezs!dP`(O zIq)e@f}i*x>L}-Azoej50~56Ct?8F7mLtFEU%L{Hb^Yn*>YWA4GPZJndBiKqu{Pa~ zIkw~(olem!H=>c;QT~&y+c;;`oqof^o&8$Q`?G`td<{+=})0aw(YOLH==C zLuoVmpL|>4gFgqDFYLhMbjw0qww+Y5`6op~eDHi@7?u>KAY`WrNx$vn{iq^&*4Y<- zdUM{n1O0A`nIC<%k<1Rv7t4;!Y31?M48&4DPrHVnJ?`N~n|R@ZTqsr2rJo$^DK zMf@DAle=W?y3~tWvd_6#$~^PI9`*oYELnFH{=1Eh_!|Do-FiN7?G=usI;r@2$OMO# z^`!I7V(Hh@2lnO2XU$5+yJug}O>ZscumWm;e9*ZOy=*6vVOP$CP3-$j?fF-N$&;?W z6ONxeuX1;okoCz~cDntOpziE}%nQetYnDANYAkz~{B%;1Asy8Mt7M6k^cFa%8 zvKMbR1MY z^MN{&^R>#xi^3*Sz2QH}@8g5NtWlr4mW%*$ou39bl*nFr(#hT%{?+NexJ90k9Ad0@ zJ+a?k$O?fEB6xo&Q^N?4FIgxv!b*b5B*>ZEeog4TFc8O|74gG|6RlUF!G62qD^?c zsgbx(%9pl(2I244aO^DR>(}J@@W5Ka))YxDz1vTFhQl^C1xU}r!JGCH!k)u~k*wo4 z;Q1Dwf~u^AthK8zn^lD}>YNXPVwrQ{L@(zw6GvyPWbC0LDfA%MxtsR^XCsDrGtVo# zfh=bJ_-BPL%;fJHH>0o9ota+m8p`6udD8rk7j~5nL)G{cOl?4?#YXmLJb0h%<%6qp zcs_?GKtH3W zwUjIG#uu?$=Ghn!hyLe*}9gW<4JOe{O|gBGzC*KvoP7&mbrTW#OaDJwv-J= za69I_k2m4PR$HkQSS;!)%ozDa|K{mrJl$);aE-NWdRinWCVDeJl|B{TXXfa#u-y3& z8Ea>Jm>h)OtF*WhoQ5s7^!xvb6_*o^*d0agiG0wF8;{YwANixQhegZz`i;vqIBlgR z*OP{`P0UdJJ1Bos9DxZTjOW$C?Qj|{H#Ea;?-2=YQ3 z<^>1t3&D72-G6(BP&kN7%GPLm(>RAV>urr&MRVqTXtoL@!1;iJPcZlV*s z6&kcBdoaQ;4Nf*@+*uVZDW9Ftl=9oA|z|ne!3IT8%SjgTI=Qq&XsAl2q8ee;Kr^ zwWwRjyze&5vkr`vo6nswkNM6XGqsp~iMixW6rNN6MoVie=AoAaqsuTY-u+8MbajQN zGxN9ZxbpL=5)9WqI=DCB@dVO$X^NIti=*9aO zrAC!D^gNPh^q#>Sd5sy(?tRw$Br$UT$cXER9JUQiAI_$DZ z!_;&hCwaghT^+EKykXPPIyB0sM|HB9p2cX%>*0v+0pt+L^Y)*ghB~v%uv{J`7u;3Y zKQ0($ZqnPhm9Hb5eVrIhhKv2Gjv?4z7>CVP%)z?O>(us;6jWAW!hm2X`Tl&m`xuVo zf}6aLmN^+tnDvyIBF{OqU4zU{mKk>qQL^|7J)sAKu_Tbb#VO=i1I*CxWiE3cXH4aF z-FG=>^c>P*m{Eexn+{5ehCR1n=BI~f@q+*U!HYA~$|IuTEc-bg=S#j11H$-z=9+OJ z{je0pI^t492;T5KEHf(&vr3!MVCWIC{Y-x%_l^EbwP=4a9kr*@8@nS$TojI&_jW1X z(JyIYkI0kre`(}cCp~e3#nmAEs!pfJbiNKf_4W^9#C0F%4*f8ziv&QI&CxWWAo`<8^)Y&V~i~4c~yTGb91|B z@n$f+wD;*(T^=hRwm2j9{4z|@&=YD*M`@n770D-#uvDWUY#A=|{<&%zulL3Z&%TI} z#f_X{J0%!9|7yu?q@gwW?v0DI@~(k17V>zk)3k6{#_N>Nk(A9bVp`~gR}X^d;i9kh zPC7EFJ3j) z8C#YtLofF4%ma8mR{o!TSTlt}5wqt?e9wROaN5P)lK1Cc zGjv{h-=pU7)rOMKjSOdZ95Jj`zq>d#{dA|GZ5<4I6rVaAI#$ilZBbLhyg}Tf9BaGl}P_2UMss&5V6OCK0I zEG(bgyj>TAdF)Yxp+WM+?wd||n5J*_SXcSC!S{H@qs{CY zkB=AYa`93H9ra9HwjK`%|41^of-zD|9kY6(@^_>E&*vcvBzG#O_ER}Yt!k>iSDdI>N*$9;=RnNfg4iy(wo?gbA%IIP=1w~Go0*4$B=tu zZ~0nldU--zFq^z;U0Zkb?W;zhP6cyAHJX}L%&TS3ySJM4e)cQsy2AOA3${RoE_5>N zDt5v5KWaGrR>6{c`OfcD2A8`%F&48iN15DbdYpi?M&%$MoZ znWDq(08!rQ`Cr}({Q2iRcO7#~^%xPxETdCeG+)HE0{hp|*L4V*z~1y)Ju?Hy zJKv-ypbG!oo=#*wr^EW_Q6p7{>U^!4zd7d+M<*|zLygMmurY#p)W7)}HQ6U;4|{P7 z9cH}IVRj=O=AL40=R`W<$Sz(VoDLy}7{*%98xy(3({wem$K=DB)bk(dnDLoD20mv` z#bwa3myQ6|%Pxd)_LdB!eR=kxYG&X(S;x(+6KVK-o%|&Y@%uB-Yb-M?Ea<;z%ieVl z&h0i}?SDA?)@w81&ga!3_Q3<&rsJ(+23i;#_@8nVzury~Y40L8Pd1i`O0_s!I?Bw7cG9B-b9XZArKPn>4ll761-Zq{^>$+Y z*-1{ncaZ|-DMh|yrnCncteK7Fh^?J$YtU3u);Y+WCr)z8&0Sh8aF}3DzmU5++ zStgfPVwY=)3_hTM_3C1o`&5Akp$f#*Q=m;ukqj!QfHUj1F1JeLO-t^$QWWsL!Cc$} zN-R?riE(PN#E_vXiBcjinQQq`%+4i4)uoOSks5Mboy`)whkm)iWU)T59=)$bI^|fP z%}FJm{P`zQYt3RPE|kCC%-C(`2dnmeu({!f=oD{ktn7z^SANVuVCGY_A2Vjzt9M`> zf4eX4exy60p+DXP(*YDtkDSRH&j0+eV^RR(%dsEvmfnCbzIfNfAA@szu!YRloqXm< z5AZ{+IsOQDp)+WdAL6b3&|VRM)v12?Kct=YTa;@Twr8-ry9mhv!9cePx-RT((O`?Z z?b_UsF*AVO#9(((b{7nGQ8M54zVGoJ-yiV(;Gx@%ILG<7`h2M$L`JY0fh4W*xjESt^N%#_jYd1fPpSTTR8V-pi`f9l%{j&Di{-uxTkakbYpFMF|!{R@YhGl zHm-`o(rCII$!=Y_OI~sUIW7L(%?FU%;{QMLnmj^3`WGXaWqX~uP0KQ|y;c^QJ~m(w z`zVuUWYOB^=*T}`ISc2#3^>l7Fn8E^Vr78Yu}pl@XTs%uCQ3>&abh5OtebT2e`J53 ztdnjzbG7`)8dhV!q@xkT)*5k;J&KhZicmbah~6l=7j<+lRxzU6R3k3!V2>b)oD_d= zR!2H3YS01YV}yZ!ZamM&3Z6YRujr6_K;Ei_kv#`yJI*e|zAJ@@9Y&^M4!sV|*~>SO zm9#8E|9VE$sW4*b1#8L3P)T-qN0~g|R*LpHNYP{V(hoVvszY>4y|nx0G>von^pGJ1HIDEK9%H%lu(h(p<&f%6HzU8`_Kcb_bd5 zsuH_;tmX0hbR9ysYGXUGDpSdla9gQlY%hNu=`3H9UF5z|fw2R~A97}UcMI|ram;kT zr9kh4CK)%#B%``kh|01;9`YWmGQ}jD`Y9lJ72>~*eVV59Pt0In>mRZZbQVph^IOi% zS7Jte)|Yyg%2j4p9;;!7^|eegZ&bNh2apk-qJ-5!1&RilVVRu*6V6n~!Rckv_>@W7 zdomY`_r-A?-CZku5$@=Vh_1}SV&CxURAxDL^F@bE%yzuM-dP)ej9cf26=ebFH;&$o z1%7zhAOPzQ`{Vi^e?0l>i%JXpaqGP|rtM&E^(0^P7(;*KS05}Z@x_I5AAH#yfQ!tH zdvwwdYBlfO!@fvs=!+>D_L+J!d)kj~)HBhTZLdL~TCDjrEzs)+w5dv6Aj5Vmf$D)wKd-LpDI#tJI;cu@@^lL}Y zQ!nzsi^(z`priC3x=ne{I5ptC*B}drCm3+sE|Z=e1D=g#)=gp-y|T<;&oE#cYeGla ztGl;`zvo2OV=CF0ZoKD=2E01V`Pu=Q2%19o7{7Ki>sCEqWMcLX11^51pRq+2RJjJM z2{a(hHw*igF_R+Ni0$uqKYcMG$g2podEKv@Z^Vp!22Wb;Ua+Bmdb1<>>7KfM>4P)RqzAT3NuXL-Ctun4|KbKy8>tF6ui|4sD zv)Y?JDbOZ;+s&)#H!rQ|+3Itq`}YE^=&vNn(mF{pa7&WVl_l?(H+_#jr`*tF>6xyR z8RqnG5pI;l3AzNgNd(c2g=7e>TOBALY3`ssOp=43>&$zZomD?`tMZp2PDje{j zAH7u*9r3cW3R!bi=sdt4J&X>l%{ky1dyLaKzt=;p!uvoKIvlXa&BJzl#yY^7=bI&k z_E@#k9$u#%(3yKf?^`PPS+d8}(h;toIY+}Y%G`wxxcN~9AMPb@mN=r$Wad({|6|e9 z9!H+AhINelMb;Je%}^tQ^^t#?g+ozDCh<);>Q7fAeTf?He{yff{h?f_WT~}@QVAv(m6aQm9RHi#Mzj}oTEwBqxbb(9Ogc4*rr^1 zD%i7akdN(N%!01PJs$US{U+1f=#-D#^SLi++1}(slegp27a};|%kr)nBcoaDcsZ16;n7 zv7V3xd+raSI0F$egFZWJ@_J@P7|C_~aHS7uHM|ftv+ZTB%1M&1JIS8&R>$N1bI^Vj=h!$Uv(cH>-0b7oJcYEU+j?6_Wo zCI>W#yTs@Ca1EAyFhJj)j*zc>UY^K8JMLx1)L^aI!-$79$#G}W)jWf2^-elF{-s~9 zGFirW<~h@&9DRTsV=sH@=hjhbL?{tnL6(1;5`GFZymkI9KPD)!MN0Vh2Af6DbCFTaebg4*3Jz;Vh4X%?$SUe zGIM%Axs(_5Ta_{cjcaOi&dn57&%!n`_=CxWc}$??!j}w#d#b zyFpGqoDAb;7rE1?lh~O$N=b}^d|qQI)(yKkBrhU@4j z0}{BWT>adLA+w6`sn-W|oNYvWRw0&5Vx9I6t=Kox%Bb>GIY%C?&@ojWzo5@9+!6PA zws-KPmx!GB@qG@s(>wx?ZbzU;f*Mh!JS+F*b8;Ykgd6EdIzgt^?oub(VY2v&*$!9 z`YZkNaQ{AQeDpSrj#YScD>uPitMF)6M%I#kEvMlJB_l{D=9?1aJz0=OT+jOsbVS{? zoCmdWf^%<2465aXR_2aSjg5fqOFD))U_{rJp1p0xiC&QZS%Ddil zU6qhQeM$e|1#<1DStn?fhnE5Q$R0taaV^;$`kMYUC_LWqeOgS`p{P{hF)}Y%(zhIv z!WIW*9_JvA(%U={0o6GM`5@QohNn*5K4t-{aj*zr6}@0yQ#O<99TQ+R~VR(SLw zPh`XQMg5kpjdt`91f@uud@?i4CGi_iH+5#JSgq4a`eyD&4zRxD$Nj@7vLN^E@$0S= zYOdoP?B)pc%Z7M`6lVCHoLau*n2#olmGK0S!Nd4}vp2CS(O8#xbWnWB=Z zwe01G$ypAJ?j%Rz97N^ZMdl4s;88UNRy?YZsyusTve$Wm9+irV{>bVPh-AwEe0myy ziA(+PM<$(rz3FAFM2~NU21=esKI_TJ?I9mA$$*wavv7-N=Ol82h8N7i*8GRpBM-OC zh)TzpAxAFFelqv*VSH^{Tx39qN`ev{#G$vHh#v-3^2Ics(?0O^= zAIyTkodIR8TsH=>J}`#o^T|aRJ(#cKg%LZi(anC;2=lT|(qnKJ2|sTuB|-ems;H#> z8(Z1(j@ilmmCRf-VL<)6`*!oAPW_t7vXGuYuTy7!l6;WTR~sv2ZHwONSe zUZe9a{)jHZ*ZD;#Ty2Ca&s_nVI!eFk&ddYqC?hBLkU<@7CD2+W-JO-V;Y{x`vpTnM z&ahyd8SZlCBz*>F11FEb%ARCm#|7f-5zgff2*AJd==c1f!Szbp@Tdo~1x!4PR*S~b za?S^Ey|TE?y3L3zcn-_LZMrOvq_Xz0sR+;8aVE`&c^6#YgZ%k3&p8dw=;gP+PTacc zWY7=2+_g%PCjU6%_EHC^|8PX7b1Lj!uEIyI8?Kktcv532!q2GbC1m~%pVx>`!#!IE zw}r{5dng%lNRLT7`3#!FS#j=#1Jrq#b0!zb%kwa16TRY_$>x*$>PUXM>j2*GYOY<2 z{>SE5HtD3-GaV=8b@C!XFI8%?p6;cW8OJye@F(+yxPHx_rNX@}4ro=O!Y9`V&d{nM zqarY#YuMw-;p7L@2)fHG9`56p^R>82G8S&cM<1E((t+;aoGw?|q;ncF?6H*+$o~)yyN(W<`<=E=ZCMyHn&*kP7-8Dpasm ze_caLt=JzDS_Z{c1dU8$e zoQuAr$eCB+GjSMM%LS|%KVls?j_WA7%KLm@-W_AVmh7P8MTN(W0jUybmnz2w>!riq zB(bf~$w|kfq8O*bD+fmmuHp!T-VVVV9WeD1^OsgKXZk_}A}-Psz|U$=ANJuh)Y!UG zkLGtc-_LW-nIUu`a{n=XtsYx>e%Kw6hv&QVk;XMXKZvzwKb|SF>4xO{@$sC(!;D;h z*A)tn+GHC;>3bOWAVo&>Wq!d-o%~p-lO2Xs$yn`(GqW6V@fCU4ZYs>UtHSqw9k3@d zg3lMO?X@CsD~VhquO~Iv*OpvMmj`kU>y(VC<8|mXifjC7_Wdex9eu*tiEjCLnU#nA zQ}Zz3GdcK!TrbGLE22;kpWq zxhI=^M}?T?DwHo(!KIQ4_C67K{F6?Gugs?USB?2w)rdI6_h&QrJvrnC^0|(#)gk`3 z9-Y`9Q}L`-YeydQ=<{%O2{XBMdFXwKndM|X9nL5`ws|N$4t?W{$ylymRsJ8(m}T8c zS};fGZarUI8Ar}&K6$hqg;;vbLXzhGkm+xI5#W z66-6a@_xQI29q0FQ!f({Im{7W)Kc^XrQ$=MS3dbN-8FjX+S8Lb-$J%dDVMtIy%3ug zg@#`;@No@msApQsm|JBsafBBfS?79OmAN0g3UH@!OR3Hr=ZWMiOZa_)gEE-WSjhFo zQa%L)*xvlL&OVmY;te!vrvSQ(swKm3@Hli5^q`;|zQ8$Osj zBN7Tj2C7#SAls*@T%t#8buVw2H=rLdArr63*G%qEPjZ-VYZL2@WuxeMBv+Mlv=IGP zw~@r=3cNLVq3~%W!rx~wud@K}uC|gp8%pI+H*XwBq=znub!zuQ6dr3PB?n5R9=(uD z9a&GW&stnS0S4$IQ`gc7wc|p#Vd*yXR(ta@v9N*bdL1pHEkw&Crc!ieTS2*<$p{eA9tq!1^rveQ>$`0JCN($ z4*CjN1Dx}z0Aq66$d$66GW<_31Rab-_NGh>dBR-XKN^aE^)m4u?uWsZn9bx)P7~xn z!`n!=s=wr)Jo?}kM8V0EoZV`^{(a5m#iUC<~Itk zB(;TX>R2p|&B>8nBd_-@6YsXLuHLP+sQfBqUzsmPwqf4QI@bMXk|WD$C13dZ*Ix02 zF*p)$w$Z;ilb*P$Ev0lG=j9VUaW#G`?(AU>`1k_+IN3r5HR9_Th55`Vz)vJd~7AX=M+oxAKsX27Kw_*L5zn3%Xf7=ye*0i?L;Y+djeelBJRh(Cx#(mnS_i)NLmmWjP z%6Z1^FDOGKt7i>^%Qr`K&BSp@cUMB;)F?dPb3Fj%6xF%*M)rwp>j2ssLd7P zN-kU3klyHp8F-XbfKfNvNzSBF(bJoGZAlbX6=%TyN&(E9v=nWl64^)I`9SL^*2Xii z+?oF_=T_24!RJ5?A9$^e!i10HQWH2|xum(IWR~zON#7{@VgEXFb|j4a^1#-zc~6;y zv2XA*Fbcgo^M2=Z(si(yX!eoQX{n3i0TXx$It6 zCfbJNh&M#iyP1if9}976a9g>1uUO(9d1FfMRxCY}ftj1h?b6R!_^?dY)aLci>sgRN?a{^c1t_qS#Y>oq?Q?0<=<^%fRNpot!TYjR$HuVS9*7|z6V0&AHgm~Try<#IP01T_o8wwjzh*_eY6awt1L$4L4t zTO2z|{~GxqtBM>1rdMEW|9F{0er@d3a10}N){K4h!{inZM<+<|T5CLf8UpOqBBpjO z?!=Hwnh`HH4d~-LNpD>ibEqqG&hI3>jW+RecROn%uS2kTEWLrB$&t-5;rp8y*&btq z8I42nrl$_Q>oDgxiT=1&39|034GLR_!nUCf5f%4PzZw0Kf0D-}r*oLEKeD41QR}mD zqbIq=AMvuRGxLsvLNU3C7BfP~<0R1McrjK!kbj&~D-^*XpLL$I?vv>stQjX~$Z5Q~ z9EyW{Kg$~A;#yx5jE4_M-wF2U6BmL(F7Xs`YRlJ^0n}LmV@q~5Ah56R%csmAs04#FmslQGY-;6n% zjTz+fu0D;I+!uE6=XHBDREti%Ifqr1KDeC;(t&aW*b;X7~BjI2n4> z7TME6;7ktXp-b+6{f1vW;w3G>7Du*+F$-IZTg!9!Of+HXxL66NcXHYJ5LDlxMMf*; zHPhc0G4+5f*=LKcrzISd{2Z4Zh?RtLJ9ymU{eD`DNtrpQF`7QmA8~StzQ3=$P7YqsGOvR7 zos$W_4a|d{Y7KeKTx*6d3#iw5sEdv$eHFc7oPV~yEXfyR~vgc z_UHY=zqiYr9Q;v9;h`BBFMIdf;`tQLf*<1hwmS!VzMC-9Cqc%OpS4X0L(G~am|y1S z=nC04cuGe0+jd?u$xxAJ4 zLh$g74rhku;9U;=o)&R3X{0^kl9*Rco^*&)4hFhbpx&YV(tHbfTcIcME3cC`*_gK1 z#0FO;@hclO$&=>Jq;L0?Ju*Lsp~RKG%cI#i>2AV) zz7K2X+M|kj7}k_%agUs7SB(i%_8gG5E9`J^Whm&UxsH;Pg3;SWN^lU2QC3*^H)0T$Ov7tq;=o}3By8>>F z;v`?}p`H?kx%~aSy15wGvEsk|u>T*P(c<};^l5|B-Qo`)bThuTOWPTv>NRBC#`KRp z%`^1Xj=QhA*~BfP`JQx}YJ1bGh3!xGS#&);NHyW8{h)>Ftf?rNK{V918E zsR^sn7hK)sz9zC|uVq=SGA#A)+&;Fvopx4l>%J#wP0#a{|4Os0wl1x5-jTB@ar*Rw z8~okJt{9nqH)-3M{wvbclU)z@G_BT3N;>PsXA@-(^9SB6N)(S%DKdR#io~_o$>{1y zVzE#sBex~Wy1Ge{Gllb*8m&0aN|J6{lVsT7B(eE?Kt^XJ%GvJ8ay%eKPXE$M7iKwi zeUu;zb|uM!I?3FFCrj5hT3N?B`LUFEW`8p`V@-o+|85aX@uj_C!`Y;8BhWSGe9Sqfg*> z0<%Dl+2ip|&W83P)2LSAMQ6_Pv!1bUDA{3y0}_5aA|qafltC)=D{w%@IA)Poc0iwS z2TbYci0btnVex=}N7D%O)Za6*`sPWgYFbqtI zfd6Rv8z-otyP(F5kMuMqhNB1neCJR#n!P8l$bHWo_9eQ!Qe*P1aC{F^W6Bj~m2kb8 zJ(wATtJK)T`uB9!=G_-Ee_{vw7Oejq_*0GNtS784WbY!9`O)b*Jj)>$eO-rTnL4cV zq_cwecW2f;URTf`JX(hk{v5eqkH$vUt4^?n??{g$>or~Yb*nime6<5T1wP3*&K}6+ z1N=JwWYlE6q|-Bg-;R3xn@iUNzxSlcdd|M-P`zg|itdqXd`%C}LmkTJ@wGgq51M^| zCwAWFz$_)cG*Q4JPXQMwaqXQ+w9kKw;YF#aJkZ( z2_?QQH_6~yl{lxVgnu?`^VO87^n?zWbR}-?WdGo6g&b?3M1z^EN$;kQpt=%Gd(n~b zf&K7-{_tggcSKkqaNG}#elnx*5&6YNzSz0V4~J8kso0UTj*tCN;Nu5Z71_o0zKBtf zZ*-?$#*Dc~nLe*q&JTB``>1CB&2Atqn-vQ{K!i+q{nfn25npL_imA^I!fkhfCil#^8YWQ z$G}{J%VeokTQxYTivBNikoSn3B>&EC6PP`?A)0$7GLHe#m~euOm74CEG4#1@ARooL ziDDRes^$iyHQ+oyd&(XDbC#cHK)f$&X$8#TtDS{=^danKy?nth16BrP!TT+JKZ~;P zl#JHvSy||Dg!S~1S(sp*g*+!mS>A z1W}x0Ja5DjM>+`T@zJ*^!jtAk*xWKA@<}1io~GOJR3UnHGh#Wv$Bjtl?iLvlLw@ma zMj^KEF=7M1$G+QSw%DhUkwzr4hrcDpUe=y=5;O7+s}4F!%P1$Y*kmh1^v?3R3VFj0 zR-(UeBO7GNbKDU;M z1@>Z>>L|_WXxwbkLH>AZBS}M4@~W4OM6~K4%9b6Z(V_P8YmQ1T9(IyLN##y#LYzu}%N@E-1Hu$2y;>m--4*CF zfzF~+be~3;WXS_^8kyy?V?R9*n@zH{A!mZy(Xli{fgMpwSezs0QoUSyd67fjOcxaI zuOAx~=#@rpIoJ%{Ci!7HbGWvU>z&t+Ua0T@bX!4=qOw2s_3%gW>HyfkWtN!I4^>&C zG^W$Tae_SJEMH{(K^Mn9Us#_Cz=#!oNIm0+w?F-0-Iw2^x*vYFW}eoXKn!O-^*_9) zrsevfRu_Nf+4&)(W&qw*XWl!1&-m4!E**dL<@b*0%KNL3jKZxbtPN$)(u{0kPYuGp zN7G%Wfx~WQqn1RWnJF4x?eb=f<4AxbfEIj zt$j&mCqjcIuJo$j;XTKn7n6O+$cx6g_tDs;AUD}SgLCd0l(f`f;CE(x1ZlAQ8r@eF z%oqtYVAaF_WKkHHw?HQ;xnI}&beZ+ef^s5RUmf#R!ZPVd;r-=jU_Lb&;DrX%xypJU zzxF-vL7xYlL7rv6xw!wiO+7URys1gAX|Mq!i`if7&i`kY#hMCp;e>V6_T(?v>zgn& z3p1bbp5%QUXf!gj(TFjAMX+@$Lf5WESjy}D&Gkauo<>%r8?%haXDn-P#LM@EXl}`S zi5$|a3G_J5=DqltGpwvz{e7Uh1dwa0+^7gK{QD=D@cy!AFEp=FdU~O*=ZvlE(!Fl4NdKiubc+l-mF^a0 zm#)}dE92;aSLx*u$?3<9zthV$Lr+JsyeAvBSlob66HC6y`q&)7Od1tzo-=1uvsUG zkF-*wp;q=rrpoS4NfP!?l6ap?mSq)M=09-`t-4k=WoqT)Z~D3llErPiR@}Gg#Zi+W zVPqc%{iBx_+frl==VYEKb<$u7(OiYrrd#RU^WC?=z+GD{{d+hjW zj{qMPO8%f%+m3dYZz>egAvMz35v$**u;wKF-4E;#y_aXS>g>;qvS&}h0R>_7I?iyw zkP#}FLjRL_%Gtb$PAD~U-*{4mmL(3D)5sCmrqlKPT7}$n2c&Fw#KeEu6*<9q%qR9( zTjYS=TO7$|sW8|>jV8w;aNV4HGjfIxKZL{n5PLwo)d-GOVM}Ll?Lh7xexk_iioOgZfK{J^jf%^7qE5$>~(+@cfA$2ihj1=TRM$tY=t;>F}cpvqQOW zJa&=U(^d3%%C9?fiW$}|nLmA%-tR;`>Llt=*_!=Y{{7eZwMzE6#@Oo-xs`iAr(EWw z@Z8V6;I!wtsQo$@Gn&)2UBsCd_Hogi^Du*Q!3P>HIWQ;nS}yXwat@{e`*r8&R!rbb z?4Rt{jm*W!K6!Mdkx@LxzS%$YR}IKT)3%%~Wl!(?C^{Ms<)M`#5B1(N$2ubygEGlM z@(e!wIvs9P{vXd+Mi$QJcnA6P7x#fTo#jlblbjl6BL%)@SW|^8h`ADHdnu4nti(Dy zC9{9HUwP~g&pbc)f1w*8oIb)+fiTObTe>(JE5qs4tF;Zwi}>rEWEvYY8~9Kbsw8J2 zzmow2%*ljw$U?U21L_ScLRyRw$2^MgGWY{r_b_|0uS)I)+DiAA^b^NA%ds0ya&CZ= zyl8KR@iWNJx32_?MP}$UjdLtlD&$wy0JPKlfem-m&i04n;XrJmlOx%hzUnXBPbs5e z@67!W+49cZH%;1RK!3|DeBmC&a(fn9+#}2QE)yR&(fjN}W{*rrtwiQKzbrysvIZ-Q zRPs>QLC()|lmW%I;_;a-e-h{f4$vT6u?=4$_^ck!XZ;Uy>wG5f<@5bm6rI;w zIX^*We9?p=Sl=*WA!jjiFVRbFYbURIJB!P|9c9B3l{8tek_WkTH+%B$fAd?u%~qoO zCMDvRD{*gKg$(LL4;h`6oelnYZQ+l{+?TehABc(kY}!oRhQ2GANBNj}NQ>!0yb+Cy zTu-XUW+CLR0pk-m!$M}}papph@-mmY7h%E|KD+sx&doQ%u743$P39gY+*$fvaFFAj zne#k_udA=4jOMjcbGu1Sk!c*fS&7$2&0x=KsRv)jn`Qo3;ulD_IOh@4{BX`b5Q~GN zk;u<0$RZk!adaK;j)r=+22&n#jpABXZ+I4t-pRzB6a%I<%7W{9ax$06rg(FmNiuTg zjk(;#TvJ-P@Z94fVIRpAC2-$VrK2R7yU3|zC0xifzJB_fXL<$vHkrZqk^<*mkv%=+ zha3sS^lSw!F{4%BKM#@lBK>%FXK3WetgnFiFl-wfcyNtj!vjoIB}8Ec+>CoR+=sEr=l zM|p^T!t-PGeB9;vvX0k%+~PA~$oj`+6>BZx;P8w$D z#&T&Es4`9=+78Q4Uag#NFatJsG)u zTiMGeZ{Wl%$o6Kb@^7CMS+!4}$@Bh9vU#jId-5FJ<}lx@ ze>n^IK93GM@(s+pUeDJNepBJ0pqrp6U)LUfUQ@>Dq`zm1SOn_D+&e{1&eKY7|uM*E=y6DujACF|J3HfF!TU@nv#s^6ZG`!>#_Zl4qKb* zAzTyIWpK_hlkKryUF~JSq_{(U|ouP5ex1^lph?> z^$1y%NfB_ih``@n)G+rVFGEITQ9nJ7-`8VL3i&1l*X75|P*>_Pi|@yMer7)x(aU&^ zF5y2pS6w$Bns;9M`IBss~nan792>?|jT zk~iO|MC=a*)MX~g@mC^xsRE8$n5S^e4|!Uixu=qko6DSpXZ{%0n~dHv4e~2#@T;x{ zb?0%m&zcFMDPC>BhGVA8`_Z1LjKz2S0~X0 zSxYZJ2N}?$lPvY=B#k$!Sjjab@fgqIA2R9kqO0Aa2tC@; z&qyB4$CB%ou?VY&7NNI)2eF9jEGgGJh+RYG0#xcCetbTDBP)2N1z!hiA_XZ5oGN6U z#ZrN(JgfQmaDD$b0P8!`Wmzi#Q@Gyy@!a!ZEYC!&AG~(=Ip8vU~DtSgZSL`Is zGM!{uRR?;YoaFDHPI9=LO0q6h$jH_TOnj_B)0gBJ+bYm+iAlcZV++K?Sghukr`_l*G3h2&0;EOFaGzeC1!)2az4}8_&c~cDxvw7Cd;yEyl z{Ng~?aJU!R-Gnul>Ri(@IETjdE1BoNX?$%PcaqHwF2ejl2gPY(vRu_ANt1^M<#mlz z@nt?yPj3fw*-nog=iXxy?BTyig&x<)rFpPlcwLQuYcl8l4cCe3YR<)}5!*W%Q)VUO zW_vxVUeu$_U_EyH!`Yz~`S|^J9@dS^$L$4qSnwqeiDr2)dr7XF&zzX63XkW`^a{UF zc$~eh@R+RU^LaC8#CSfs8?Tp@ti{i7d{B1t`LidOe)_IX2#zC9UDpXOhdN@P4IRGy z>4>}>j-@Nr`0<|4X6Fb@c*S}5_w@PX>oCBRvjJyx2r%g2v7gVKF7zLs%EKqtavKKb zL34e=_;iQsnnLC#=v0*GZ_yx(( z*pl(Sk&DH#TqjC%(XSdgc+Nq2*3LtJx+-n>TJHAa^SOo6L;sWP-ZO+#@`9@kg#+1y=^FBh1DG=Oejo@1tLC*K*Ik0Hlcqdu93O1ty0l+WV>t+}43 zDm?0wV@xaJtO7qj?J=!XFu!2y{RDCNMo&XTs_a^l-JMr4#`ECBTJZ##KheOI$#zad{X$nXcobJm1w}=HUHY&W`3GX{OTS*f#o8BI&H6+tZG(X%RoO|2tQ9 z-m{fFv?h16*9W@q}H#oLrwniV`wI>2a}8OHW$UtUvj<^bBY&7p~E9`YFY1* zw2wU9;9_}xeK;14kHVt*oU0-iliItD^k%;89_A)rPKd;VXBjxWuMkm%ZKTdblVlHP zPIN^iToeX4&nU#8ZPs$nuS9$(Ey$q8e~G_%N!numU1q=RQfmf0!Bn(R&hE; zmc*Mn%7qve%v{~#U-F#)t}y<)EE?0l#;^b3+fpj}m&vJ? z%#E!b2{V5Ei?~8mYSC8uH7S$SZoXLfFbbC%Wddo1nC)OC%bAbd!GYeojZugiO)nmK zw-0^WNnrb*l4s?O-33ulmoRrp$GPEl=FsH2NS>EH~ks?Y1n-$KS+E0(W4 zeG%|63PXiiOlJ#l;{$z;_bQ|yfnGWCQ=48hr<;6M#}jQOGyfu|^q2 zj;~r9v7Gu#T!Ot&p^rq`sSH$W#+hk)6;E>CGsna{<)8Ez#?q^}p#YyAScxBf6pN$1 z*`H*N!Vm-I-7bW4WgGcoS1MzJd{8qc3fm56Ah|AU_9{!}4Y8hG?2XzNqA<8aCJe0m z_qb#yRVSCok5F&?%ll{=d0r2HdP^s@5!aA1aVB4Om3ht2^cko%s{m1}TgyX>V%bLy z*Pr#@wM#QG!iCNQk2a#PDwRj)ePA^|5*PZCALR9~-qlpJXN#q3Fmdo~q zJ{V7jh0nVTEb7Voh&<*~t1{V?47llqe*AY0;(gbU_v6+9?WEz-U!pngg?oYA368#gc62i@6fTT6`v& z@cqe)w2(jlDi$9*Z=Aod6}`@7Ku^whXE6IHr}#YS?Sq7VQLq`Cfo0BrA58iR!60M&!_Mc+G&mmW7ycv6Yn7E)%O2eBNH7w~;*Z zEOOKBUenjv^QQzyd7|IKNQA7&K%0~TlniVyr&|A(lV;?^`8<5hGs5UPMy$MSA=FA>L@YAPUbyGca^4-_J%?(j&E4mbCI@?nx9~j=cVBl8+wWPX0Jm zEMOWrr*DaN8S>Oqif$L6BK9?#LBHPqf`i%J{$ESK?k9QOj-ROxwQGlsGV`Tar z8(e-Lg24J(yzarw8FEYucEvEy$PRNxgu<-_-9MFb;j+Vo^q5#dku9^QLy^6o9=Fcy zZAY81{z{_UVjgH$yHGq|L_gP=90WyIpzp7Jbh_IjjI-}~oydRrX5+gn^P{u&%Z{41 zc+;HzzOh;?ADM%%Jxwq)jFB7#lpvZ8hPXxTV75>D^eV9A^)YFZ9G&Xz?U2 z8?I|jSZo(7eUfa^u4yRh*^rBwk&RBjD^TV8ez||#7K{Gi>m08|#E2Z2tW4K^p25P|Ja~pRT!oQYq8lxPvUVClv@%df1Cp>`1&s;Yhkiy zKJRQ3ec|M@W|DVvWBvP>7L}aoI;x@Y__d9^+jQo%k}Gt1!hGa&Ik5S}oYr?SvgmKt z^Ir$!b6+hs?aD!ybtZJLaX`xY*&=gJC>&>M(VXvFoEhg_{-z($oIbuZ@?0ymm>y=;w`8`~^Fl=R#+-XDUd{M^f|`T15- zc+4fwc<&TN zF{D$Xq&>95@qTJFHRpA8AP4pICS05nD`|xw_>z7I5h{J9^5nDOq8s+_Sp43 z6wQ6L&~GQ-x4MEXK#a8BYLAlNOW>r?VRSdv>Z>wG_)ff39qYiHw{Z6Vv?yE1S)Vs1 z=z1TJ$!~1Yk-XlYWm+`kbw1|431{xdOYs>Sj3cjCi|_xA*lcuYqwuKwGeNGGS)tOx zFnk)W`!8?%XHyeCMaPS})E4W>sXa?$F7tpKyxGe8>u{Wm>0pa()?s*dPm6uz1alr% zVB?$vvh$=JM%D~P#Fr#=_?iPvV|p9=B*;x(Z}sQXXZMrYqEEA-nOT7omhn>kfHgd7 zgre_iE&fQz#>`|B1`dpuZ#UXwem-;67w9mxe=c_1rMI+woE+_GhmYiZ&7H|D=Fq1} z|J~Q;^c!Z_qAIhv*`D5+~93cQ{4{&9KD?a)JTmK;7w2O#in6t*~FFc-mouZz%4^lB+$Ci%py8 zOPw4q#?$250{D6TN<#U*Y?%F`=dn|QbT+fa(25YaR@cIH)c<^uS>I#i{!BY~`-Pwr zpEIu(vG-C_;Sqd2MwTX7qjXXzs`9#8`&SOu7gs>HD^@C9vqjyxAsAJIvv3Axug+wy z_tFG;>T8WTe4bcV=j-pyY}BW`Urxoy=QKNHFju;BIdi>vogb{F@YwIo8R?bQ%&rN= zxOe2KopUgDe+3#^BuLO&8vf!DjJ888`OO!B zIxMWlK9f0p_1ak3pKk*X^I)u=OFlF>2dRAitUAFw^mH4nTojHVOLCEebMU^M!oxC( z&zUpKa9bZnCR&S$d_6mQIw&u!4i1*TQ#74zofym6ZQj$v2RvNq+rbzWqiUUE^NK7ZcXv!fE@Mdgw#;dJe6*p(<#vUKu`?|JA0 zt@OXftU%`M9Nfz~dkd{p<+J5bZ+Zj{B+CWXbzSf3WZFN;;@V3q({JizZj%&w(wQ}c z>&bG{Hc7fhCrUqaW;#vaoa>4N`4q2{R9@Gc$WC5en<&#VQe~u9swg?`DvCI{SRox0s62VA04xh@lM`^jWYq43tD)doEr z>*_fNp~H>JdemqAtb5~RT%SR|&U!i6J<8x>cGow?JF^gZn$${%#Up-#kW6z-x z|LiUDi+l!e4Ax;6``M>i^J>mIPI#^!D%Rf2*XdBNrXKx2>F_N_hv6FLU+^__)#~uX zH4mws^N{;1AJme=F+o#F&7EXSeLiu9P&)EiSy}WNMvTmH*$#jJgo7~ zML26zHw?L`@gWztZ1NG^IG@?}tmm`m-PFVx3_~8?vSu@VYaV;C%$Qc?V(7_S{MeI+ z0`|WrHOWWcZg~hR$weCLOB*LL`)!$vczSh^CWQ_%Xp6O!SGSXPSDZyR&{^IewwH`v zE)sjtN{+p@5!>sWm;Y!Z!;%~X8Ifd08je$d|-SD?TM8`h2^%rMMKi8Rh3S(LGcJE%g6 z)yzHgrQaY*fn)r$dkrReTv{##MJCaBv1c)}LIyjVq__$*t0$IAj~E5dzDiu=-%+_# zfoVOI=seXVw^Mwfb@D;~;mp|>Qs+QS-bI#i5wkb;2IBcT zI*ls)FuJ8bG~4`9y4(l*Hqj9=(;t=I_+w0@AJ(wfJ&*kXGxl}Mu190xDh;|^j7Iw> ztdHL%r?`PRxl_q8zGbdaWHg4Ec- zANFaGH?!gJmpK0z zNQN=IPZrFt8t@|BfW}3veO1cD?Y0J3tTAx!O-GVvCJq#4(cwiOq=~!(zfVGCdL9i1 zD8{mvO%}5GNcNAd*h8OX#5~sg>rNz#=*QkZnDKXfF8LuMif`D z-?Y|D|~?sx@IgyBQrKi5;Z-4F{Q3&0a<(rLDL% z`z>F(nW6O9GOSSc-vL>jEGiSeL`#uGlwNPN4nG$xBDrDGm1yT}BQqo3&8+%PM zW4Iao9V+By7X|k3Rp9V$vJfZ8JG!$cNJb)=_nl|90u5HNmy)W$uSq6R%`205Ka)Hf zYm#q0$wWHR?RdL_xsK&B_+6RYX6AZ9JwJ@h_r=5iL)u%nMcKV!+XHrY5Q>P@5O#x} z2X^1Y0JhlOEopZFV`8Ah%m8*X45+u=l-&h`o#ed7{d=}|dp^MPhZ~46jMvOs*IMh` z&;3}dLN|IEU)J|Wlj`IWhp8~JfS*L}d~M>-937-aR6k}_&m!+opZU{UqOqoPG&%*UG4Bq0bH|V~ z9u|$lDP(+#nDxQmSG9^7-7UzFsOV;N;>Q6Q^qyVB_V>)H@=so+Wb(72csg z@qRk))nPU(YjVpX)6k(~I=08Bqc!VuBbKLQU=5x_#q(^e9rMC$GZ2};+>HffkdKiq zCf|7b7kLzpso?o^TD4Ed!p`K1_`MINlb_i{W|B48+8n2US7cyCB)zK-@-c|-{rdKw zVBWp}W4(-6evi59W=5zt^L#a;0OQ<@@a|rK9#sl3fa5Irni2Xqj-51qoKt`@%L3H$ z;2(~yJ-J2%?aRmD+jO#=W*ze#&j`EdD}KGt2%ZBu z(777GT>0*|yV$tBx=@h)yzA@=yY!LMPU*Y#i}nmnov3de;-h~&=}_te+hkAI4l2)@ zVGB~LG>h^mdix@^-KkU$&!$y9R{grHuit!{=ak`mmS2Q(PVW!d2Tm zr#@ibvq!SnE!WAYZCVMsnk0)7H8MXoDzWa03o4Q`{J5K$&)?`*v~$5?_GzBJ zt;BDg3j*fTzs&mzYyxPZgXCC`zxMnokALphHtGO;5HBE>4YqgmAj}~b<4YRq(G?Hzsr%Zx*E%vs! z>(Ga5L&bjbkRCc*iqavay$)Awbo9{j9Et0|YUa6kJ}et^N9JH?a1PR^WuZjP-rHh& zvRJPidz<^Qw)C1!$iW)_Y{Y1o1-g?xsZH1?!*ykkLaz6Q(bGsSX8T3D(CYGhFp}#= zaznpz$vKA5cf&fYjVcFT54h*!f*bf4PD z*!nKgLAjjT)SPw5*#?YruS7O*$DydM5gk$9_?OXwC@-IiFPJ z91{QCi0ZS9XrgW>JyyENd>0p~RohJ#opzPQjp#>=;aYFMImVI)DSy}u;hqYN)sRP9 z>5q1H{`jT{q*FNnUA_G=+`}JF$e(>nqEC-=b;c-iD(jgU6|aWp-gKxqe`aT#T3g`_o;@f7rr>}D^=5;#VkJ*!n zE#=fQSLqhwBx@@&FMMDdNqJvNCp7zh7SY)>)eO^{nDgx34C6H_U~nKKF6oOr?T3a{ z{1KAui)UeK#PRpL^4b(Bcc8`w`mXLqq1|`#f_y%`r)5Cr&2`r;KEEHl2bmSXZX#Wp zbLh`aB!fDZb2YEg&EZZm^+h{Lhj!1v4^AnFVWx-Q~;V{SF1n zP%6ov*^kiHAOB{maI1bG2BrHWF@t~Sn$+@ZG)DH|y|)GX2>AEUyU7&&HDK^H0}}Y& zSvfER^WS8k?^}M}`V)>UDnK}`?^Kpbd zk99_+$QjnohpLk09eW!8lrf8;whO**C3BJQijiMk@u@F+3j4U=M@~3yB{1_PCLG3v z5oq{4oLnmV0N1m2&bcRr^U7I%zSWL<*uhDt#C_k&Q5^IAb8%`Wb17$V&e)xUf8)qI zkSDm=jgH2z3a@YELhA8rk>v5C@6#=O>zK4@sFRM}lI7)Pogjd{kK`}5dXkIls>H)x zWG~9oMXYC@eC6=6eD!qT%oWoNim`$m}JnpG&59BpdIg-o%q~F@&1%XCjT3~ z!Q>t?dGB&B3&m$%pJ@-tTMQ)A-ZKfIw{@sv(BbiLDfq#D0kR-U-d`^c;=S(!J;WdBw&MLLv504yN_sBd z(Ql>AK||hmCi2=ebmcv0RW{;+6<#l%E4=)(6kd7P$fxkEeKC2$qJdhOS20Q4#~hVq zlaGkiDV_X0oG9z7lO?L+3j0gU?Bw}Vw};FS<@M=2fG%bCaM+#Ty?JsN9tALa77>VU zLU(3EEdqH)v(hyQmaB9qc*OkIOSxDufqeeD94t!W{Y{^Pm+!ODXtKg<+#vEzWJ1>4 zntA#4W$rY2%Wd@LejaQuTi3UhNn_mPhSEizJW|SYy65+;Hpe~oU_IvjVtgM3ylR%p ztT@g!LH>we7>HpO{%EwE{MTfEICkMW|6Vi#Ox#uN-p>JlS){y|TlM z)?)X>Rh%u|IjOioys<5RjXrqu{QUTFX- z-}A%D@&4%e$`4KEvNwxo2V=ErW@qg{`**y*b3R--f%75fzz450F#8Fek%Q@9&Q6EL zsRA6W#d)yBf4u?BNZ?+&_#E?$qn*W`{NlnX?y}>nv$VBiPi)Ul@(5-as4A67;R>8? zXp)k}W~lO-ds)9g?BJQo===Vd8WVu33;p2Nk@IwUHOj2j__CCHuSJ}f`|ZG|Z&9%K zvWFQ{8}m%xZapUpXEL;=9*4XF}s|5POg9IRpVKZzY4h> z)i_#*+~5c98HdyJ8OM7o_nS{k3{Z|_7B^orhr{fh;CiFp_cY|+Ex>Un@|D~hy;#b7 zDbF%4j$}W_J{R#YqZ4{*Ysq`tT&_2El}A1<5-`&Yu9eH-!4q@5sH?!$Dhj+gSth*) z@a#$F4|}^nwCbUPVU3FU&jGOZj%MF2`|o(2QrR2Of%mV;*n#jX+#~8UFd;SroxC&f zF(m`NUNdu&uhqqMbRDaiThW&Hu2sf=L-FBkg!8!^I?q0FuBV@M&B5_nxtK9j;nmqv z;WgJ+;bqDB(7gw1=AkNMv#D_a$WHt7_P33;cDIDorBCvBlug~Rh{GJ#NS(7sJYL~=*09%Du*#?D|{xxgz z-xOZMxkoOJ(@1lpR&MgzY+kLEbIUYRvYR!DJuX=N-37TXxzC*ELYE+2mVCc7;e8@u zM;Jc1MPP&>9JRkPgV3Jm_SJOQ-z*77lXX~AJqfdRai7*C2eCXKzx0dzLVcD$Dzq7!;CYlM71KPLk_yB(j)ScO*xKmY%EMvuwOWEXiW z4S71Rn~~@}!hq_N^I>LeBKwwc#We4v*+Bv#^zI1!YoUyD!fZqVV%`8V2g}Q0u<6;Czt`X;1Et+|9z9Y3TXw zBl^v-kV|j=NXaN~RDH=DVe)rQEAmkNfsIrjQ!F;Kym{}BLM%C^0ewEA`6oWlgd$l@ zzU=CRD3rEi{%qfTEL+q>HZLud#(CZt{W=N<$EV@Y;g9&YcN0k*TOy+;`vG5~cz(vL zk;8fHW44ry)eEHtIiLzUdg68(xE9RE^%!fh*8CN>LO+;gk{`UsoZNGHI6JU~_;xFj z?ujZm|A@l%)6Dh0%G{94*FM4j~b*n>8&_EAnGaDH;wn$varGESxg%2kT zxc-!$z8=ogQiB)@56Aq5M6OO3`pTwg_@|5E0;jL1h|clrva7fI+?Uo5P{{Ni&4 zyt86n_S)u>FtbR~zxkqc1G&puysvfVy|m0io{_`dK@PED0Qs+q2Chfh@0?~W4|oQx z^7lcqo_SF3(s&K%yL?brM&2tDpL#wh-5iO;9M%r#10A8NFYkK%m6bfN?Ny#U?5T8I zYoCYJ5e+4CCG)u3_@U1$=58NPLvuqOOh21T-4!LWqNfim?nS{f#sG=T$0+*m4)5pd zYwv^d7LnMUuE*--`B;C_PC9y)$fMGKaN;n%kRTs7^&>s|wo+>X{iOch%ycGi`z;O0 zw)q%QkKWSm#nLF*2cw#mJ;yxD z=UJMC)b%ct!lmR)yVGfLihN}b^UXOf+P(iPrz`s6C;2t&Yy-J?W>^F@5@+usc~{>L zo(}YeKTE^tMR}0PO=Sb?an&7t@ppVQLWLZ3MXrq}Hxy&TQt3fn(wX_l-}t&49rM{c z&{ziP3Pt7ai$JbZKD=O#whuYta7)3IBDrvcIZS8Bv62s+Ta$i3dIqnJ`Ym}sy^-EF z8eZg-Q^|2Jf80cN-TF&L#T!-)qEMxOItnJ`W4^DAG*06D$@lZLJyGy)Yry&6VzAnv=autuoLBu#hQxyIoU)lNIM_663l$BA15_OutH#Z7)`OIyvmXCu+ zT8MkQB59P#|1amOn|;ZFUd%`B06RHV@SAfY-w)#=abdgx1#9#0rkACd_LRwuFW$J6 z7KxZ(1MfBTC$?)L(`y&W=7XHi2S;I4fdLku^H4OVv7FdZBs0tVAjgWYS8oHF?jq+t z+lF&n)ECH(^B0L-Oml1D%SYn9x>(Wuuu}YB1q-(E*7b#&c%+)IR-A z#DKP0nC@Z1ME`g?haC~~Efl{jG#Hbag-zxPud5g0q&Aw7(&|Cbx8^x0j4Q*itB2)TReB5?hXO0f50Vd! zIaY?6iw?-|drpYA4a27%8vG`YwuC%ah1G||u+tHj>V;y<2@QVm-1^{7@=6us=~3nX zYh);HNAUGMMqg7oh1bYmv2wkfBiarK#rUTh`i016IVrqs*2c-Iy3BSO913?nPksMv zI*r(OTP|J}+-Dy51p4Ew$!VU=f?s{^0s6+Rd2F_=W?Q-TacjxO^g*nu#$l0Z7u$%m* zntW(m=9oLUJ7etj5NH=C!m5<-p8|eAbCaieI3kSP=(@ieoLi8^GiHTX*D0}b`jR6K z_yyC=pg~9Sq$NQn6Z8+D*D~RN3~o)QSZWwz$%`eEQ@cE$ zx#5H8I2&n?Y06+MDo4NM)-3e!p;yijCqB%?nmL&~+VVuSh{?qL-h7^l1o;-`jFzi; zwiKF(nOm~3W|Rqy+8&bE-yP7ma2a+D(%}5$Y>dh_;ZM(4d34Vn*XdjQ<;i@~{^Z~q zD!j4}kW+h2zAru)#n%&2I-B|FCKDV69+p)x_E>)+6pbp7m*M!WpJGDGLmIiv|F1SP z7$??iu;d~+TyGOBYH20yIdj;D2BYW~$JfU!Slutfr6&i)aL^H1_kuCaQ;V&MnOI3) z&+O?T>GsVLrad8OI7EvYO|$U#dnvwqCrAf!iwj*s@Qv4bTTm9_N7KhQE>>=nKegBp zf~DUR@gO-1ip3_xlh^B4n|ZO_L&@zV;#cD=7>s2YZ5=PwD?4N8xG=J=TIBDizwciY z4*%LOW&FJby+YxaszvX)%#ojFf>rWCxn7HIkLjV9mO!rXStffsO*m*BCy6tdM_e-m zU&(dW^&q2D)x`V@t(;D9!qNVrsGUK+lJnTCg(h50jg_nR%s5LAMaMx}OmX7-nY>VvU-RMKS6^g)H8a&*a1%L9+A0x?J_i) z&nyGZOAaSYXgVWK#&|j6o@WSD++Pfu#X3?V^JG@XNif0b9JrWtZ|N~ z<>8_F+mFpWl2^L$)|9O|E{@<7D^>tI4cxGi}dk$_=&SPZUE04nL9jPAYt8`oK zT27zvs-5TZz+GM43bm<2lB#-cHM~vzJ9U9RA)t}xd|3|Np7N_DR?txBD1SZPZ&CIo^7ccu~>m+goSx;sTeTrsX;_gxTFow14IZ0wu zGf6Cl$IG$DTImx*=OXhIs--1KC^N%5)r*s_RkYH&k%s4m8rfKxJ+76tvM^99Gh#K; zGDsuGPbA5f1g&g1mMAXE;^j^St=P6pl8j7^Y@W{E_D{~tO>sdJa*OrZkAKyR{rBr# zkj}mLmnEzvkD*J!$_?coDe-i&8|-XS;C$0+f2Gg-u5%#psML=?xakJ1GW zt(o0)TnRfD@`{t4k>skRv(pt;^^|0Nlu&SNeyqzq{R=XUN;ecJmFOm}FiQ_djSKYW z{2PYqDdDKf+Vj^XVfZ^J9AjpO!{JFdtnP(jYQqRDUmK2Us&FKC3x`Kw7@q771Ddi& z{|$Wsox&mW!qER79Xrc-uKgqoy>F9Ubfw?megqyK=b1`KDECpURZA%1U-At6Rv0`R z@f>_*IQ|~v&)KoYvxx3t)~9Ro3_P+5dr5Q2AdaSQN5eHu4>}mnYO$#=GoJc0n~P`X z^(}Zt#Pvx3Hmq@6X5INGzsI0uEnSD|adi0{WHw+HYY@wM&bE{8g89sd+NQ-3GaY=& zSl3>|IycYcezN{ONR@=wQCe7w4(s_d4g+*(xHkvO`sZNI{%knCqI=OU2NPLuK7K0) zT?)zY^L%Uu|LsL~Hp<DWXL38%(jy%Ua>OAHT+VFg5IcwgVoaId8 z7IKC@m%BUMB=(?-#N|55!AMt$Z_`nFpK2iuVp_?-vvkV6Xeo^%Tg!yu_OfoOgR~gt zB6Ci+m5c0E?`-Zacjq>jRyJ-j=#ah4o@y_Bf3au$gsZ$OD#Tfyoqih8>ZOGJO>9E`-VBx3zagw3EeST1>D(tUvnW{DWlC0>7YPsC2I}$S&JQ` zK*)5H9DPO)&}wE27MtOG0|m1mOJ(phlbF*3ciLWo#9yUiWdG?_{@a9qm{09Zw|zqe z%1<;&6R^ksAzeZWGyIG+$Aozb#N^Wv)1yS9hMHvc7UmT$qC;*^sVEnyuEnX{V;Q?3T=C;kUg7uLzRc3 zIK>bDcJ)VX7rGvKu086P9|k6JZ|~1~_HsXX-ws6T7k?ax2e3^u0xMkNlhG(<@k?=Q)0D z?&TD3xZiz2zv3h^QX|y#_ebM-fAR#{Xhd16(P@|(!o5p&1-cif(P3YXE`zCb-1Biq zyQ^`Fwd_Isvwn^m<}1lH)~7c}rN-`@D8xNXN4X%@{dr!}D}-*vII;-O$X)#;mspid z0RMgCi*)RKZonYcd`8*uTzpgpwujUGb|D=XSmU^vl@8;PbTkSjJMh|o$+I$$&+q$| z!QS0W12eH%2YzWll@Bw{>)V$xlcFZ)0hJG1u+*_V`NVOJ#g2^ zUfrSB=N7$k4UMRGg}H!}3gE`aue#BQ39ad8s$M{@*oZJCAD>R5mD`Ls8bo*8XZn(+ zGSh1Sb13J#%d!p*a`Kvkv>DMtEbSd-SZ#N?VCEowPV)V~#!ZIbcb9}%XZiY;u7wNq z7cFv?F3J|tu(_RFZQ4e9Pj!<8{hZ|l$CP1~oxFaol&W2vr9(|;ahPi_A7?0Kev$L=}SLUQw3cb3Jf1pA{Ip) z6Dv(Jb8o3kcPoeO26GH#9qoQU1=cK~YimKNtfY&v*FAC&niBcYg*ojH6xbG3Dsy_% zx7dU($9U#@)+m$J)k`HhvW)%F^r~{4MUrFOYDGTsrUDC2mP-9@3M}qzhT50SFzI5M zR3+~_F;|7%WK5nPQNiQ03Qa38OPZW-UHD4XL??*<(v`&HQgNQIr10+GYQ?uT&! zzBp_2M*_!W(18HdT;hvCgH+5C-GQI0I8F@odc0x2dJ8prsoBSwL1$^tXdH85?&cWg z%k|+HSf^(8E3-HG^&r;q?rvgkSFjq(`||4?Hzzui8SbsdOfUM!mXJSgy926L>i^aH zY}V2<#X4mF+G>2_`E%qDj=33X%nzn-^$>j~f#g~^2CF2Ji7=33Nio21Ivr!%vmd!@ z1}3>>pud)^@ZNNUm8Rol_Y5@mrHdtuW05tw4F3$&H>Vr5)PR?J$W&Y*<5)2R>Mi78 zhNfeXDFatob4`!o82yxn!?QDxXG@<8$LOLW^2DrRt!}63=~%< zM>vx??O*ay`8hqOkBxYCm#lB55zWm$A=sAgQvOl@B`-{Ohu0V8v%WE6D%rz~cVvFa zGX`20U|N6?(I;73Eihu#KzdPGJ1oz!7qr%hv48S$ZMPBUjr6hgp#OvCTz^vNg&b)_ zV;_1SryEgloD6aT*_6RgJk))!>CHw?*N?mI=9zf6xqh_SmefftKXp!<)HC&NVI}?T zRv$gRsy_2@+g!`@Lv9;=pTt3)i~i=O-b?J_@gh0hb6%rWo|&o^`q1sc`U?ZDd!+5@ zkk)JAVb2i7L(lp@CV4jf)+lYV$7OxrXRr1Br=+I_S8tdWS6R`mSz8zVz*Za2+n(8? zKjPOQZPRRhs)Zp@mgI8pzV4{ZpG`&)%$SbQ$di*?yS3Cvvz0nwAD`q}GY|5HPO3hp zr(?55#?RA;{S0!50~2N4jU=(uYUTE=MA`j5QFh!k$+$487>MxWlZ;Pf9#{ro@Qx%*wj2 zL}TuUD^796f|{;SDqIoT(FF++E_mjrL>TLAJJ-1IUO_ki6D6}3*b~EEmtzf`F<=Mt z;fQ$8z35?bB1ln3`+Qa^aY>iH}(!3HNxuHGHuSl|G5Z#KQRe2* zsYkYv_0y!6>~UE}ZgDf$f?LVEaQ!&*64#F8fqMC5;M z!i>r#n@KnKu5A2XLI-#ezt6~Zr%w*^q3H?vK-V{WYSb0zz~Q=bku%qhSN|{1cz>Of zT**;N#{#9?%yf|c1+8V_eizB_W`?IX&9Qlvf_V#Ei#eJ>ZBSqb=ibb_Dp=kLz||bC zp%$|*V~q+K$LROF#yK!5ntAbDPjKDxAv79Wd9VMqH62-;lfpPxZSKS@NT+nPa^hUW zb9C3?biBs#p4`QV49*wB>1>KyEhWI)MLz#>laKpaN!>PNF3ylgdqv(p#|$Tn znYY-8a7cKdQd71f8dGO;9BfKWl(YU6yID0B3o}R`%XeEV?ZREvC zdL#4A@TH3xmdr89nQ81Ja5aOwy*WIu(mlxQV@F=bdQc#qr3B*Mk3ekgxC2(_=m7SK zM&52ZlYT{Gur3;j-^mrkq+==P;nk~{i}{TAf!XPp;bp|kLv%$)v&Z6M0cLQ0v%!`w zTU`tJe#A{C%xWchciT#hg3A5*9fxuFV$rFc&`}F9B!_;%&s%9^I|$Q!ht`$XpyOz)QL{-OrPCILp7&Mg3`ji*)bmE~g7yi?Y;FieJ0Rr^f6p>QoNBcbK84 zg&Drzq5t`V8S2u5SZRw2B{%)aSqCCvgFnuX48)O%bV#sn=NuW0hUa0#M5D;5d|Y0Dfwy=c(G;Na#P+f|z9n$o|6eE@-jK1@>Odqx_~snc5j6#?omu zDI8Bc$)g2?zI)_gxo`a^2#ll zf72|7KTD?Ipu(&7BYLeylWWXYcvalSe9W;&q{WUTDdzpG`x>3hNlX!|={k8hm06um zuBcYq4Gwi%qQ-3{j`_O4+AIRjY2hg4JZm;E93{`g5Wx90@0Jc7(>Qnb)?%@a`)8h& zPvbtkm~)eFL^hnKlG__YU*y?rIzVzUg$&~cvMCeu6kcz}Fk3m73?ay)bx4t|r*-1i zBS}`?(Mh>FN92nq8IcfI)c;LJWtS_4v~|VLI9Ci!cfsWY5r_{8M=f5X6nzIqb({u6iDd){SWG(6TJ8(kbRdo}4 z@yTLz9gZ+FkfS;M&2Awk(T@1U^J2WRJmf_G&fv-=#E}J z+}Mx8JZ|zIhR)2T91+1B8=i**M&NdNzD~TS1oucnxSl+{O%nD`;A@t}*XS$f=9FBt zypW4Nr?PQ#UN-8|4cUi$!#r}0+YJh@>*OCcpC$Wgqm|#+j!Tkjl5D4+xx=Icd9glO zyqhtnoNP+mS~uKY=!So`@eJpS3oLk^(w_YSDZIyyNQ}UZjBxfoGxLIHA!l#WiMWSc zWw|88{9+F^&v(Cm&jt?j%%NN^Qh1JVlJ}td-E%N{Ed7<_QsPc2yy9aOUaAt-7Q&bl zR-XK6ShAcLMn`lHoeaLBm38+uvLCK!`G}6ub#555$`z}x9njb&9ibvUd($d)e5(k@u?# zW?tiY9$(m+Oi?X`*Y+!XFKt$M1=MpD#Yk6aUX#6Ht6ZgT)s}K^OABd#&m&^Y@JI+Sz89T~a31)BN$mgFTS90ufr5nGlct@oOi~ z5IU>L`m^7Vd-aOn$)i9My*_lctDNiI zR%(1EG>C7w$ST&h68S93HPWzN2Da-WCFWTsUB!n+1wGS80I{`H5s zYamRARd}#58gF~4F_<6U^Sv|wU*?0KBIEdmy`WARDEh?y%On{KFcpHks_E*WPxCRI)RsI0N}x-}PL23&JeNsG zCqI-9Kd*E+?%`Pt*Jb8>50^h+L?rKDyJ{C;(|x{|>lI+aORbc?&`5V{jVz{re)fc; z@`l+(*87xj+u{n(a2HHTChJWOY;ZXxrgJ{D;`)C%KRPXn!0!|E4{}ai!*kLIZ=Tma zX74%AUB6lCa5qqgUfZ(BB;}yN=WHB5l7qF?=rO;OgU-_wUZwviyn+VuKDM5|+PR#I z__fnt62-DMxwxh}X`??b1ISv|o=6V?_be4TAKoyzBE*OD^uOH0Oms%UlL+Q9vKHzV zffM~X7jdufnERCW?mF}}@Hz0laoR5lv0SIuJfwq{F&n+x1eVr_!0HVVxIk9!W3~=K6PfdKi|5K~*jM$FuEsdt zPraD$lbMa9O7^zb$-zd>i@iBt_bpU-b>cn3K9k(}d$Mv}&AcpmU%j|8MSM$GyEv?q zfVW2^dt{1Svq_d_on7Enq(np>-OJxyvFVu`9CKaa?L?nIU^s?Mia@=%2y7o8fd&t` z7n_y@6YECW?|d$k=>o{qqRCM*mWy)mbZ#!j)?mN=Ccb8sa?tu}Haa~}ctzdf^&xBC zoqY=_oTs;}Qh2pEqLWI+8gZ+WBClWRm^q#zQMZ40XMkMU~bhfXJl;;h0;9&m-!w(U>%MN31O&voo>z1IxJSv6Un}~ zxV7{OyYlY^S_GBPg|RdXN4fqPk&^?%dHSk(PG7?J?%v1rj4Y!^liA?r4|z`=_kVfD zoZrplR^7i+bEOY%FQV@+m_4i=I0m~}%kJ<(X<6SFiGk!_5}6Zvf_cG%8_39Ee`R2- zFP&)Q_-3(>wG(rPM_S8p^-pR0=^s?gi^TBMH0*4Zk4csmGIDdVw9fTLxFhpYZ_?8j zNN?9(3kmZ3CDHf1@%Eo6G$XHfYh)hcE;p77^pvf;Ngv|fDArlh@OwCOevdVkt^vjJ zgL{er!y<9&mI0pD^yRg%67|GClDWzo<*Gy?x;DAXO8K}E(nvCxi>+4qz<&jK9GxDo z`Tg+^$UQOV^wbe=G^77+gtq~^$Y;e?Zz|=Q7E8CU{~)z;6x5cy*B$zZb{;l#F#eJG z?t`HyABCza<^{DTSEy(#R`i-3ddcS>&iv>#hT3L4$9iBb{zZReBsrspGota$j`Mm``pbG*$gVfvB)g6;e)Dmv^GvQE z`Jh`bti){d9~n;H-`|;$2zjqZx9fRWxyecbpZ}DpO?}X&Be^88jrNP?b63?F@+6m52NQ3$brfC{O3m_eXAP%R&Q!I_9C_rbcqEYOzcV`Ukn(N2Mxw zALjjJ{Qf4AdjGF1PV&KlKjhbVe;%2`$KTXg;9Mf<SMa`Tw0tes(8)j$;eu z`ILX~d3Gf9Mg0Hj^I%zIC7&A5*GBK2YsDyBYsS3k`pnx6qaX0nZ}Bhj1zJU+yj>c? z!}IZ}26Km_isfV{Urgy1i6K1=n3lsl?nVuz_6>4gV}0?MuWvRvzCB~}@Hf7$3|v?w zWhyVV<~8p;(e{4PC_gM{*h-rsZK?XDjh|^jjXy@I~FLkvQ@v z4eH+cxO}3a3{5PQYfF4EGk|_fGoG9N{D}H@tz_ldVrfr4@!JM+fBtE>A^G?+yp|Yt z{FT5F%-tT&9P<{;C8tkNd7+uyoc>qVSMY_!Xy%FEC(pYjA6GlrNPIPNltDg7;&r|< z&48AD$Wd;zlk%&J<@}d_5IiIbbA!|2q|U>nZ4D&qL5Wlv?+ukU3LTmoSeMDe*d|RS z$f8*EZoZh$@!Kqj84=_h^L#C(hD(u%i!c6d5{cKP^eVp1qvN-}^t|y)QqB#=d}S1x zuT8_({^SZH8%p!5^at?yS0J}&|1k~Amgk`?)J{&*XK-tSAG$q>g#T|n=4kU!(8faY zDlvzBhYzx5M8bnS;Fo#%@HRG;(f|CGm8E>Yb%;V8zFzwEeExGS#AP+d#U*d7{7BxJ zXUapSO;@ZW-M>iAR#8FA^YYI_ z_&9vM9D|$7<>F!)L2qfKO%(ntqi3)rA0^fnGMN11@9o|=dwe_8ybd)+v!8Gzxk7TX z#tJ^DG=TZ_k!h&kh<-_WAsh4guW0Fu)#O+=H=xh7=p)w6w3AuA|Hzp4%#Y^d|E|hB zkt2Cnyv;%uX-Z|=2wx0Y6p1kfk z0W-ak#c}cIS{gpw%*QZSYx#EUkIcT|4NLPVoV>#MZCM^JOll$l&V>@Q(Hk+LQP@ZB z_<`{wTqZXbed2HNnc#yD=g2QB(y(uAK7tb2Cq*8-a;XnG(%TDz9+SyY_Bv-HW%K^X zUHUgKa{hU3oyPModTHNUi_-K*GB%TkZOn`)8v`Dy@|kPgP@b>)EslI0$MAhv+|+=d zmds&~u#z#X8^!eV#gC~`n9uLO-6apR`m@&i{+IOo=8Z+uSyOZ;XPxsAIynbuGAWUCDgsm^gWu=ZN*& zLU7xP&g94}tRPo7h&?yI3hmJaVd#ELi~UWqFtohFYeJPc_6#^;|9|<{ZxZ3>%AS?0 zWtg`wR_e}TzH0C?7#zqq6=jkoD??@5y|Qkv1AaaUL7jh@yIPio6K$AzF_hfd0cY4H zEW^lr4Z7I#|5c7$q-VUGAlK>NITX?KnoYe-zu_ViE;czVbLu(Z(C9E!<$m`;a2EOv zHeuP~gJM&i{94x#^w9DQg&dz#Hxv6ZY0rDz;;O@kSFf=g1!obbzKP1d)IEIIlCYsxO~^ zK&*VH&(1S93|(t!;dC+^%O{yI>)~OsD|CVb*F75Hnsj3}-J~XDU5J&t^_|f_ektyn zCnE44@}6VpS-Vbe!!HN?qPNZ?Tm!cgS-AeO44*q3lB_f*oV~)Y?@Pp)Hd!d{Z^AA2 zL*lWE-br$x@8@Yym9LjW4}SgMLo(gyfIe=)Fb~jR!7ZLc)HEUDCcnSX8Sjn+qmr`* zq4k(A^t231hsDdpSO<)37mTZMTHNE~Z);>?AJ$>1HQxylw}P>W=Lyc2m{VNagjYH7 z;`zY=d98wR;I;;{$j$k#AP-o4K+;z`(0d(%G>rz94e7Z%RR-IDco~-G0Dp2@#vh3o zUyIK_yA0j?9FSSoP6&D)0*i_oEH0OY7gx&Ar_n)4ziE#fzI>m5X72WlOgw2=h6Yy; zNN67i3?(<(i|@Aw7R+IHRd~I3J|y*iIw2+{1ntQKdYxx3^P4hksvaxd?CAlt3qjKn zS{xAi@-CTR;_IlPk8cFI)Sw0$^!|~FnoY?6c0C~V-~=1nFgmdKzBOfH5&5+tulWBZ zKfAXu6#pDbgfscm!~-S_>2gpKsyJg&awx7;(2_04MD>{_%-eWSO7A#eX15S%wrR+& zko!w7Lx_<%&Nm#e(K!U&ZMA5|_f_qq9AD%;jakk(%ir5-EWNAz`o-xcY-aB8c=Era zINm*z6ET9krS<~|peL3ckv68_qw`?_HK z=Jl*tm3i^xNfYlMl*D`o6dw&m41aHredMOe! zVVO*iXZWNL6g^FZ9XZXScjRGP?w3Q~9nomnGTa}acgg`zU&lQUm4F_!bsY@fptd6l{L+sI3D+?_NhpWChs4-X!YwH+OC;l?ryBu}~u z^rfyc;l{{A0`izK;mn=q{N{0u*KMo`wwwp9Fh|=oF$8_BxM#e{@lsrdcXtm<`7aJg zOA5xqnau5NPQIS6%m1sNG2n_%s`k$@{jV)%`WJWd^{f7NNZXdUHPt3;yJyE6D?MY* zkJNX%ZyrRQQ?AStWzt4ow4zv66?FM_tnN3 zRvVOPI-Fj`d(OD2QsQis6S^;ULE>d+tiI&}aixQ2k&?a$7c60|`OGmFoFDHBKb|?w zy6A!iYn^eh8C^X)lsGQzi=4nS1WRWevv9%DfzF(7nIYKG6&rL)l*GE=^KCj`E71Kz z{#e^1j6K2h>s0?gXG489GdpMiIYgclwe22((yi<}y~rB1lD@^!JV&1uh7m0zurfEC zS)n{v;@NhM2Vqz`fDT61N#4E>L(>)P#k33OeLoa0`EmCcW?lRU{a>#AAAYVXA*X9g z-%l@Q4~B*#+?>7$J-v&E&k^zFFuob1nkj#1VVSo2Ba znfV0XoBcQ+SGmu%&|4ic=4z3%NsF<~bvWvvMcFi-^G{?QdN%Vcc$QRSGV=$I(76-A z$Ni>7PyZy8EYQ*Iz_Sb6BKgiC;>T&ENOCgph;${7yFa*4fNh%mI86N&IiA8_{Rc%?L?WMp!pA^jQQoz|qft*MD*<~gfO~$HqEM0Sh z&CuAk9A+OT%SHFfy-8(Kj=$ppf9_RlGZZA4WKLX(WNj`JnMs!;*~HD4RdCqHoF`iq z2DVVaHOP*;XH#mM63lgeddRsvwg6+djN9A`NP5Bhtcx`Sj%Kh zcOd_C_DAkqo{21rg83FQRT?r={?U*R^z2Whv*sc>s7v%C_|h+QRSi`T`NRZ%|5iGO zp0oaYhpvLx(U{2nPOCT3s9BqRZmd6SPN7q7N;IO2Sr<7T4f_;kReLks31T52IUdIrFa;7?=adUc*>2i0#QiJ~5#24+ADPOUDCKI`S@LFuRv$ z>ATW#$%3`&&l$LUjV#tTvXaUSSZ}A_;XLc-v8?MKNoTJz^ZfRwW6Xwpe0)sSi3~&| z)*~)>8j*j2%;A2z`p+0qJIIKx&FEJ;$7~6nr=%{)M?q)uSNDx%28?*c+SAC<^eVo~ zhvjRsk^C6X8q3GU1vqT^2_++q$UJJq*N_67QXBCzhOVgX%%5CGk6Z)RrmGg<@+Bi~ zA0lT^m7HXflN=oEEYq!=q*l0{+$(dC5sSzyj&PBlUF;<(hF*n(HlnZRBIA0xi3{0B zpX!b>&x_e#x7=lX2X}eX)lsVMwUtt9=0&@Fgw=9*q>zKKIvsB)=(%s-$Cez-M z2QD?qd)7U!c2J=nUb{)cS3X z(s~N$oyZukQQ*5?flCo|q;f3AeJqw)TgX7}HN&F?{QAFS96Kp6aY2bpsZu5_9TkXJ zMu(!OA3~4&p%KSd&T@YYTtwgLGk~!4^SK6|^xJ!k_$5p6eOO~J; zGtRd971SJS z&)=yq?wg8kMHM!(wzFb<0HR{m^mIhynkzHglgMoxAy?uXO&=v|KD)@4e2YeBj+Jd3 z7hiADlUkLWBLA&j2zyl>nC)IejcWgL95&!Mx*rYoPqM?eqj33K6xMx@!sIsm-s?PP z>dSHTiM76JSdnAr&oBC*;#eOWK$mG)I%2n_GmHDb^HTb&o~6^J zO+JU*$0mEa9+M4lvE`WL<1VU@f$;(9uH zWLfm5%roN94%S918PPq7=aTCRFeKlIrsN!_XXfKXPcpt0nN2p9-0#tR94jDC%&|55 zml6NoG2(s)j>(Qj9G^|DIGP#o>H?_$XIk!MmNbZ@*n)O znrE#39IpmG=0T3X*s;b7pQ~3%8(SHv4+=i$d-u%LFPmK_?c=Pl-jAMn?AHg(=@s9P#|O^(GjLH;dFkj%q+$^FwP zbH1^+v;L68bvDTApakiEP%me{>Sd^nQC_bzO4QZ^V)>|-pV4{=Wk0A-Mb5}n)=Sjo z1M-VGS-q4=vN=tO?OR=7ysE^9ROTGiQ{mBg@`^Fc&6=vh@)gc_FRtkLi1%`?N`y?H z2kfDWb08|{8mO@iN({(X;aNBC1<6KsJ?VmK@h%wj+=VVfH3mm=zd47TqeY2D1C@CB z&J~Y`tI4D*;TfXB%MBI0i?cE1V3uR+XL^$bIcbk4qS2a$gI(KbbcgPPaF|e=mnwV4mDtwj?iEg|jjVTIl$=TYj9o;r{PTK4(_q z*^A?S-I+h=rm|-y^k3`|nvMK-kbAjnK(`{!shIV+pTJod-j_#^QykNj`D%Fv)N025 z-8Am)jJrqrSXYzN)oRrnlNjkv8cq7J#n7d@E;JH&|W6Wnh;qnGi9 z5sObUzq&VBN3w()*!%PDYsRm}tR2mv!z_S%H8b~x-kd}EV#b!w%!W3YG4dU2IkT9f zzLrs>z%H^ z9x?ZUL4&gX$4k1}XCcLx-kCzy@3zrFL%;rizj{n|lTn5?^4DRdM25ANs~ua(KgCL^ zFt8A=9lx^! z5qgc;q1J)u=^BVb%XBE$gPy;IQ5b0zjg^XMRJf)?nBoE&3?o}GEgj`D(#Z~{BXv+Z z^iK*9{k8xPO39~iZ*kY04>dXNLBri7baHE16{M7)RZg-qUM&X(sN~eXQfb(Vd(?ld zvFpAy292Rt>K`j8&jn$zX)vyZ491+jbXfA2YA2bMjZtu{%=ct|6fE4^)oU4z{x8YU zlLr}6GaaY62ih8Kf?Fh+_J*A6IF}Fm7j%Ge1|y5t=IS*H;4_du!r`r?a~C&ptm`UU zSGvk|i@T&JsN{JHXBkdfWB}Ls*Ig}g!chU^cm=kO=6h0Ig9K~tUEA^XM3Q%yqd|BD za{b)*y=_UC@J$_ObGRn%Cf~^Q!Oi0WZabu-^&=BTpENNWoG#%f`RF~j0Qfy^QXtmb=!j^4A!(q+jFSp?aw-X-YSGJ9<7JaeqIrOzf5P zDs#<#e1Lm`7-miP48X#4vPF?PgdEo~k2DH*8%CkkMe-oa`TDM7rwuHm~9__}tG zi><_cawGCPBTSgmEgd8IUYWT!9;!DXCWLH%33I#d=A+N+JXF}jp69Fr+{{Rn1Eq;F znT*5cZ3Zd&dPLNVjM8^BvyhDJnTL|u+p9!VUQ9KpE@OE3H z@ZLr@<06ff_r->EDCv`=+L%PSIWJL8lASl)KPW~rEBC6?jWk=0e9k%6)T&Y1K@C0Y z0Jq4ctlU8-V?23>y5ZR3!+ZD`@*vax&&*#3a%qEWBx3t*Bc9Nm)S)Yx>DVlEsFRIu zH#pPREE|{Kv!}1J^1ej=%zU1V!7zn)!aRkyYrewU!GW`*@rT6R>yX%Yp~nEk@*@IX47?!3*$$9nYsHO|Jkwe-}wXXD^PdcU41yz}X?WC!_>x0?^~Hqahfk<*#cwn-Gp?-NO*uk*tgZ>m_{8u2xUPnd5wqSR1)EhmN#;%mSLttkum~$oycY z=OG)F-e=;rOmonHR3t!RF@%k>lP@=EP2lZxCVphPWm_ms-vW>&cU zq=b2D^!#nI!q_dG?<~}yN?m3&EDgf)8Dt1glHYqb7{vuTSa=Qm+%$?a3_A2sM8T#v z-M*P*DVxxFYe)7 z1ATv;p3@ttF2JX7H)(c{{5yG;(SN(hn3l{oaCeoR8jEb*NalS3vrNa9%9`y8c=}r; zbV>jo{|dmWZGkY+Wm)4z0Intk;^BuVyloW)JksGe@4IU7{W?*P_huhW=zQ9Q`uvRc zaGx=}UpkJgONXLb0ZhCnseP7=WgPEWYUSfyf3B&G+llocr5u0kB-husk;<>#r5=5j z$2KeA_<{ANZ&s*lqN|#-dQS}&$>V#`Fk3^GtG(<2c?cMsf|k{g&&)1ZG>1h3{~bbrbfmgU9Bh=gE9T^PXowNAru>dP9}A z^3u~y#yNUO@|L!8X1SBRT<9nvKP?i${m!~!);NB?9GWVu@usUa+TYTk`Gg?+J0%eA zCpFm2TGgzh8XVrjd(L6>LGRbWzGoEb2hs=4HQs8v3CnqZ*_L$a>oVL3~e{Gin;{6)rl-U}5r zjZ&lM02NwUxiRxR97kixmp5i^aG4e@D*ne1@|sO{*>SEBH@b3u+$IsDUh=%3XT;D` zbd%4d>#sZKbn?xpSw0K1+AzmvBG-xcblH*rntoK_ZCS7I-o1t1+NFsyfcIZN4jQGU zjb1KKX6`hv%=21sK7jqEuTz<==b^+y*2mv*O26^^xc?<$0ri8X?!9+&L)G-_4DcXER5z}{jDww9s6g)Z(}xWE#&aYqurmW@K%vM z-(A(p`(JYBduGsAyNdkc3T8KLOO#!A66IC@L}{4F*FYaYT322N&nV$^hS}G=Mi1Xa zF3udz<3x*5S-fBJX1|@D;X8GV@F_81@e=y}9E{koAQ2B=aNdgjJ(U!*7`yQ|-f%t`8$$%loZgVeljm?>SV9jjm+hIrr6l968hxMjXG* z8u_9`1TM)&RDL#W`eq^IDw#cgR(1uP->1uW=u5g8L+OKVLhtcoUayn6&W}%&|1$LE zJN?Hn9unW0NwUR5FCW*s;L1TI4s=%I9Pc65^;Kdl_d%Cd@n`#L5nCJvtH0<;s2Gmn z1GIP;ZA6l9BIfTkVC`1khefciZ)QC|k9pTu$iJ@6!W1j^%9Lh=`(?o;k1TAo!g~p4 zChW4A)5y;TaAe4QER_g`zIbBkMhuceGBRG<+sd+AA-rVta+Y>+K2OCU)VtE78XnS2R}lk-2BzwFJNR)r3|52eBBGIPKm z+0ai?ESnnnqVu%C)eW*oZHCDrV zdnDAXI}ZI$Pvt%*nNg)sy!tRFdSWCjY7;(x%)#V7_VSv%gR zX(yL#f5{_0|Ndr?Sp1YfSCxx>-5QAU2{}Xu=5a6KziUb=c08s>?_Ya)T)RY4FZ!S~ zmA-N@%)#a+@Z%%U6DS-rjZ!Q=Qmx<#S#ZcIkl)rGN1UO_WDSC`$$ja*<4Jo z*-+-4E0Spye6ehEBtksX(2_jkGKZ!zZ|hHqXAaPP<^tQMry*e(dC44Gxp9o=#TP%M z&Sn3kRvJ?I_+|?mi@73?+h|{W^WxqrCKVnxbFpDabLrqkj+pOrmlYAPI+}{PzjINm zFS*Xmzog_7=j5kG;>G1u)Nsnf^x943#pFU6MgFwpKqUP5KJQzQ$LlryedT`0&Gr0T zsz>6uGi$bUSkvTQOF6h$!ruDhY(De5`S@Q4d3;uGEH&eQOV(IFv^Fy@yG}AroAF}X>A8uNhm++Ih*yqU+zjKiK!{{6BOinW@65~>tlini_w&R+}ZE}v~>B0Q* zJ_6fT(i_2_>(r>pV63jvWRe`3ia7D0(FCl7D<^D^Eg7C6e{>uVE1|^Z3klVZK$D z#!{MDEX$wyyM*1nGYVu<7Z+HUT$wHhtws~y}myV z?T*0EEr}}63x71=an*Z!D$d37b9Z-;ln+0p?NUDfY`*@5Y4oD!VwW_PE`5rn#TND! z>as^hUVFk`=0PX$-)sF#ig-W&E12iw)-<>`&*NNTeR<(mD2I5y`0#js&(Hn#2mV}J zTZvg!B)8aq=u)0P_m5PRz05(Kke6RA+NxOGc-)@ib#H+kuZJhd54LJ5jqJ!F(zk1~KLRr{$zz_$h0D0>Fdj?Bfehs|W?ni45@)fZ8r5lHo;uQnnN zvA-J25BD3k-OYzD}f#=r$2GU#eQ~YcD z;o4I2*AwV1*_?~hpX|i(=1-aH;g9MMBQRk$=c+=;vuh8?NqP?#8kz6e&ww7}$mTZZ zzGTimsmodUaTP+bkoS07N;C0fH+i?Zu~Ib31y7m;dN8a;GbegfCO&7EA@l^F zXRb5i6k+(-jXA151pjcsgy+GmmDBkYnhB5X16U~tzu>2FK4=8L-5c01SGq0-?!9)%75>b&aCnE8x;(fUIx_RUb%UB z@?2wM!kjXFOw$^YwxR+=?-y-BspIKOh%2n0eE4 znR&(It$^OcYE>*yk=wdo=*L2##d&7egw#OMGgUR1%^*9zzr&di1 z=Gg2PUp|k=z%cCO=R41fd*$aA#5|7?|G&w3#Rucsk_4>0Y{s+z3p(tHmFaHI_;*kU zF7bJ`#%H2zEIpDn<7NE6u4t?aLBJ0^Uhw0`G?56opd6@y%dUF z^oRQKbF8EAR#uJY94)!sBzpIn8<^2;#;x`i^mdPz*T-Fv+J(Nw7J6JEx4ZXK8E`&U z>e2J)Tss6a4klnX^Q`Ss%JB6ouS=U;G4=&LssRREI7#1PJoAW|y*ufl6MR#H=|W3D zS1+D-!DUz!y-%*VJ7FGw?(?ejtDeY2b0-U8-D0KjpGquP5C#u>1Ltot;dqC+*s(EE zJIDn??gV4ZU_E@-WMZ}}Ki})I(y56HKDmUV$qe?NT4eJ6vkWa??w3u>AAf#21Xs(E zJL2`Kp1s2RNU2^X9d|}&MJQIx)??hn3~UH3L(!~Qsn*67+v$EAcSVoV(HY3U#(!7H zemTbL?fV@ec<9G`_8%EIb)yVftM|!8xMC#p$6Jrp!!DY&;zPVH4dr!mC3$UnOY2rP zpvi|!tmNw%&GXB$+6jy3g`@=@BW7k|1?R(NCd5i&XBTw18G_$DA6vCEV-Y{EW;q9B zz)p|C@od~EH6p{s+jOGzh)n)$OcEpT2GBMa6!;*^d#-Hr5U zdnA*6vog+x9FXH4E@(C-6w&RN+ukP=z3W&|P)#pS$2&tanY^=?9+49{<2TPj|9hMy z)#Ld>-uchYdemyp8UjDxz*GCBksZWlsZb}Gt^L#h` z%j@l;|Nnl*cZMn{o10jte0jGv#k%RT z_fig8_42BFJ1FJeoXcI@L$;@EdDq^vC^J6gervtw;^%$6+IQ%eQs@3)uNM^>ru_V) zlb6#N-(=6X1{w4&QA(M`^o-2ynN|jQI?E{b?UUrrn*?zxV1GH;AfHN^2Uzux4_mIsMEP*Q#(XalQ({-91t7kU*E%RK_;dK}s zriA0>N#+Bx-q2)gIKp|jTXhb!s*N5 ztmR}a))&(Q%zBc`$S^D&5r)a5v{=wD47FKHiJl&cwXCIhj?iLHKP_Ihp=;-K7<#qV zV)T)4{O&DTZi2=vf88O+J{hd4YOz8&(diPi>VbA){ z=SJw966t;;%gA-M5&vAuI43%ab+9I69dFVBQPGH4KlV$0WaAa<8DFxQ9msk{1^%kl zpT3dYWMN{Y84oVfAv-J!$65Pm_R|cnT-Nl*lTGB~ zi(<`KzTAw7EwiARLw^r@*0Ke#5iha$=+v_UHbV!!Ju^d5RT2Ot3;@ zw-P!1MgiSfiyW{ml}hwMdL5;Uagzd{uCTA$!U|hcm_xn6B15VwkWn=VHt#h!`Ba0Q z8V#Pe34(Xz5Y!m z-YEz{Z#3|3Our&CrGnGg$6XnPkPT6|k`RRkI=U3Uv9DrBZ=xz1yAH6oQOMk>iL9G< z(V^P~9lC@@p<)E{6&;uz_>S2Q<8+w3kvVyNna8w@xz+3u?`WsPQWv@#mymrdBG<+G z|JP7yY2V@ype;<^_9>t>n=Hb$@tp}ZpjoHJAFkv!#0t4HdFazmG|6xLx zcIh}-kcM&W7ZkN;PySgNnmr*?)iWL5@5p8yp<`$wxvCE)=3bfbVZ8~_wJsoSD0|~m zO&D{M^NZut@Ga4V2j+B~KV?F(oe94ius`zBgcu85a}Lb+x|N3er`fmposUV^*h4C% zFOI$R!%dh6eVzC72lM~uf;j#?4`Y(pYrjffk##F$C;AlstI7Mbe_>$XqA&e%&U7)V z^3ivCKK3jkuXw!xb!*dUF*G03+55S@njVR9WGY6}B^Qy8Ug`o&>YI<#{N8`AruOW~ zto)+@<&NiJ!futQ_BzSG^j^gLc9u<9DhW3@OY}NdIpE_aB?&HasbM=Y7CFgnty&PvZv%Y2@uJi$Z(tH*8u3}zScA13o|5a!6 zYvwI1X20s^Oa<1oS0H%46_$6U-;{o$Q@u+iH`pTk-dIE%Q!0wn7OBL?_%tn*@3*b6 zvX>Q>9xss{SIQ*%yaGdcKK8B349U?7Jc;M?6)A9j1KlG-t#GoZ0(F*IHvupo8B9Jh5VJ37pjzjT*|E%^?nmFm z;2@NY*WgAt{ii`1_?rSSWJw_A-`3!EQUDBx0+{O;fPF*#5zsggaa)<&wo8MR`^YZZ z@%hLpZ?z4??`Y3FysQ|Fmb&(GVeGle|WVP>T$)JkTiOhp|w9A%b;o;|e+ z%yPe|gZ`=x?b}2l<9;Me^`cSaqeJ*#WPYH7$2=WO3(3>Oq~r8h6GBF?M>*Yu{2A%! z`S%6P{lwYo?diDPAsuB8O^7(dj4&q?de%t)A7lJr09{^P({b@TYu<-AKl;Ulra5GO zU!Zmv$5bBwJIERG{74<2|G&Ou(q-m(?8!$1{#wa%?)1QXY^g)mMwm5yDi6ySGBdh> zv!}?16>H(g19@((qPy!B*+&yIOC0Gx&Ckbu2l9lrziIQm(u%_FOY+o99Wx2Ct~yHmUj_ z`%_LdOiIb^_d2=Ck1Jm2dNt+TS%*~b<$tD3`>aUW&}dn*-I`@xFNPgVQFklnHFwn- zFUy>yls!xQy)wI7d#-q>PX4xHYI37fjk@mFBze~H{p__r|BhG5Kvl}V-)B9yG~RV~ zXVC^Pd+WbF>rOSwc!fb~=Ou_^wo!I1NR;vPZIwHjDF5_Ll6{;{sqC2`mOBR7RTM9M zJPq<}p;5kYe$m&KKCaJ3xx*aI1yd6xIsSmuJwTUt$zd@xFv|NodWm^%l+z&zGWBVq z+~~`B79_~Iq9n1LGsyCviSp+$gX}q%AQQ(O6xZZLdCPs?k>~8!_2qu8xe}G8st^{a zMlFjH2QRo{{XjLWGn5D&LDuj#nZzf|&#I(?pD$-#4l7YacIEH&bar1#coQ{NH>dC9EPqZr74p?8>};*VnKHV(zq#VjbUx=l zoO3y*Mc*;>)(@gXt6ey%wFrl%Rv5|$(qVOz`$O&*1MbjaHCPM7)iC^g8OrSVFsQh1 z)K1f4#9d~c{RlzD8DZGLz2ErtT4ZaqnD8+SEMLISS>%6${Ba?XVkP*B08_C)l z5%%7IH~vO!`itzzNxJ^6j94|D+~Wcxrg9&-l7Hu=ZxTu`(jT?ifU*2KVx0j#JGq}+ zOGf22IZ2CwjI;s9SG*SuGU5dHr+Y>uV$g0QezE>`w@ViLyWE>C$wD*7Y^+PoLZQjb z*UEiiWpartSyv$Ia_tTGfRo7_mY8wqMHWP|5cn7W>}V$LwB~HgM>7sj%tHJge!mr2 zp-k>Ie{=3-a2A@^F=IV{#@M1PG*yykJVf_nlPq|w&c?=}%&OxavYA5`qF599e|g5) zg(`8=w2%)&oMa{$xxbGq<;OF%j9X=qijGzYx?+X#hEmzsfvjFj1y1}7pf^N=KD`1_ zi5!Lu4MhIufd6G;E}tI7S$ED+T&GvMZxnQMqo6&=IR$UJD{iD=OSTDh=Ckic9xP!% z0Svr`?7p3cVY|4V^LkOWfHMjY=-Bdd6zlO$lKg|c{L^mIca58z;C{|nS|-U8$m{L4 z!jR<(l(SXf__F}qIzlGCEB9Zs2V?bYx_n3YBYmt6yX!_{u8JP(>d~<69EE-S_1|@O zYM=?f9+=QXPcL-ebaebD9ao}0pj(FmJeosBt|PC5L&zAsE5P;5ZZe6^@^#FlTu|gJ z>DFyzxLs@cx$w8VtxzhxZwnjUYTAVe>t zmv;#{`DRhbc}E6gvJRj6(ZkJs)``&f#@c~MSbF)GfQIS!u`2c7PHp64T+pVcp3!xMTIAhjPE_`@z@o7qBo_jeKB{*E#~&|R*jDrM-4QaRtB zUbF^Q_~#n;11}XYv%Y^YIRL#62EcAe5PlEf`}1%xvTp^Ty>%3vx6_3@NQd&?+{at}CWeHu0|G~vL2bkyS7Hi@jtH2SS-d-HginUBV`$i{=SEM$2e%ypB~%i4)k z+txD8(^2jz$j)?gmDeR!*d3w3*ah^C>J;$c@w9?pPo{@`4(E(Ee$}8(@4+Z(O`ql^ z&Q$O->KD!RpZjWOuI1}z>rk^=6gto1esz}#x>o7f%Ht@i(1bUyIYYqL5`Hlc@-Yuz zrjV=DGDE5;56xE7IQN?3Ji;{RP{5{B&f72rJWf(Rt<@NPEXS@GM#C_KIJ6R2=$-LK#_|PZ$6MOCrj|}2IgLqQMpuu8IaeRUoa&bz9SUg z_0B20dyP?e-@2jj_8?zy{}OYL@(;=Oaz=X5jWWwVQL1X_vfONx;?}NcJ5h;Q^jBWu zeCWDfD*6SvDaW-jD!@}&D zE&QAwu?`YPH*rsLpIp1%vMyNa$oGUy(crdOe)N;#9| z#vBU|Dfrb^W_p&%urt5qv)UqedHtC=og6&ZjX?+fG2(ato}SVmCxdH6C|$=vye^t` zI6q&9*tO~@oWn9}^2jR$Ne@t4S!>?|1+5ZuZiVHcDHJR%LuZLT2o3Lh9I$j)0<^GZP zEM^m`nM}xBKqjssImSX}aJv_vbW;H;Jj%z${B|-iw50@EwGnl1&IjypmB#noq+$l= zCcaoB;U4EzYtTLT&?29PDexdO2pO6{OiBvGx5Y!?N*=XqX#n}}NSy!0dPVIhI5mvs zJa829Ogc0#HNkra-DBI+@N9+&SB98SnXj?oXL9eq@)%*rdyVE&InHu7 zrG?lZa^^m$jr5J8r_n|wEjwDIC+Ga;wzfj|RAzpdtl+kQv$dW)^(oE?aQ&K|lLp0N6K1VQM>f~@N+D-Ye? zlCSxZPwzxN0>e0$S(S5S9bDwcS=I$SRdne%N!=GtV))Tg4pn8A3Gc^G6|+wE-69QQ z%4Coyvlbo%;ZZjY?#>LvFfCtGrUnBiXmIWadCF^CPX|Py+$kNLnn$4v?@d4QKJa5j z6J8xjL-7*2vwb;JIyxQgxYww1AP;fncuZHw$JZRrmhC6oI6huFbxoA`enzQN!p!?* zy_Ci#N=|jo&~H;gUq=nkAu7aGAOki|iSKS&{861VO&MBr*g@vJGz{b4hv47qWR=fy zCTIrdhHSVOSJ3;%{qyzqX4s!M zZzAjc%^(Yo7^Qz@gY^H0HT3&QGO{R9<}FcT-aI7+4O7E3MG4ahI^(x-PHP{G|-s+WM zhDVCRJNK}{+jG9c`(c#A`_WEvX)AnVy9Ij1$ih@?<-P1!q6}@8C>^#P zmg@8|{J~zt;-g0Ca7=~26Y0=huY`Mq3O2vh7*pngjZ5er7{vJr+hs6tE&cFPi?MlO zoW0`fxM)ON+e9QcOoUG-W<6JB-qA+huXto(l$qSXE7q+G>5k`n^^NR(c!I*40x9q5 zQ}{kzBYV1lj$w^aRyZA$9Rm$Ac4@p^a56}PeVm`zpvI0KDwNA%rhvN}4r^4f=4UvX zeStO!VVvb+4`F#Y=bXY(E}K68mGmFJWM1O$L>%V5)x#pX_jx}zz919B=9>{a!;H?a zSwm0G!UBF?jk(8IOAeyt8in_1@~|zE6y9Fk2emv)7QZ6r6S(hCpU_L~y$ND9oH<&j z*+*HgLI&@Lmj}|RSzCo~PytqCVHapofoppgn{Z6o9}Xuwy0f=4uY4_M*;*RW@0Jnq zxdz-GO~!Gx8TC76;U+&fk13p4<8ht-gR^H|oDJy7wd(|5S7m;7Yw0?U{Qr2ye38G${K^ce2QMb`CZ z@_y3~amn<9pC29e1Ig$6 zHI;~nV%a^+2W_X3yX4PZPkyS_*!nV9e#xztJ{aRb&WOCyiB-99{?NX(9G%^p>zc&`ch7$R_!x!@-Be6W0v-+dx4Gd`@zxscd2Dbe7 z8Y7YYAqBUtf=1jb+o)Qfc|89~Nlnog{yn=feErAB|-~N})9A=7*DZkr+aMV(HI3 z{1sVWl)rz8h98QcrzI5+ zdEUKjSX;VQ{~^aNl2hY(dZrT3yCJ!VV19I!(L5e_9A@T4!lPd*UXRGd!MsNDeE%=$ z(uCKIk_gO6<@Eu%uwK?g2Czq$FwCDBrabSyr=o{TE;45~7n817!gE+t;rSRnG7U?g zkmt>@6VKve*)uo*6Bf}MSUC;Hp5W>%rR=HthbTl9L7ieMfOreV!xZaK~$uJOaXph&d+n2K?F z){^@-mtQS-zN`yCi)YMt9+`rwOLH-zc{9lwP%L*gGJpB+NGO9+;ocz+VJ&z(2N%jF z7eDOk9*MC@sm#zLCpe;!oUij+QWw+58WI7ACcNGrCvRxyEXN1_lJ2}OxOX@bnfCN| z@c3D4w38YBMKY6~N6n%LY*-+(_Q$xbkr*|L$NA1&&O6nWZ=(w3 zODlhLd$SeI2c)5259XdPbCC6~eoECCA9#^BJa#q}(Y(&bHEhoOy6+O}4dN;2WTstnC{#L9>a7lfP&#+t#boBnOa zgePU_dgOqN-O&=`tC9t1MQ&w2ePO@L(D_B2yddXtnmM7LR{=^1V^{DqH1F0v=@T2ho*}cFC zPy9on7-hg}TYA10mBFpfUa3vq=Nx@ub<&xOeJO+WZVN75ijz(J{*~>)=;UGG{()XI z@->Us#LM{(%%$xfhNouc+a_kh%ApMFr^U(FDo&i~3`OZVJpvzR&|j+XzDs_p?ksXu z?L!gY(|`?pyzfBraZ~q8{nO6KvI#}p>japlnQ<|l`M-MRQ!jOa+KKz$7YWQ1$Uujw z^cd2U_}1itZm0PC-t^f$ra!4SIiq>;(xSix%O3^fOpzWQlj()LWx>&7`^4{qGu~}s zw!#KI^UE?(y@J9!VqTmq^K!%l`ULw-B)@hu6FamPfc)v8GfwDVBN$sw>Tx zdi}=JgGql}@+k`roAyiHe$LpGO>Q*RfK$UV=-4mAmTIx0pXQ2V14D86sh&BK88|zJ zye&D$mGfNS(~WsjB?;)CVut$&3%u6GNxN3gi1!SEIhWo>9{(-LyY=qBU-I5MVm9-R zU$FPkWfA=c9q74J>Sb;&y^1<|=+2W*+?|2W#ieL)ley}<$gxTY+T7IR%=-+?>S)2w zeX;U#q7%k3S9$??&+8jFvwFO}7(&vz~NyHgkGWz~Ksluii7ivi55B0t#7-vS@U{nE0hGmfQ)q9S`L z?qbH>X=S)n6e|&JoH61E{fu|@7+RQtro+e^4&nL8dn+gMiS5{H*;y_VlgaaLRN# zL@RnTFUH5nz!+y#oD>2Zz7G|@XX17ly__R<%Vp-C`ArN(&x+(R-)7*CrOc5(v`?av zoKb#u2%H^QW8?eTqGuT%PD+plIv4C^j`??9$13xDi9Bk7P1yli8|sSRmSD~sGnY9y z6B*|$7;d*;YCAdO;NDPFU7$zErVQ4{$QM70lj@ExsMwR7CeJ(P8JRdo&e|;`PHe`y z;@>@?ND@7|?&0-qD7n|q2c*juSM=Qxj5$*cNN^;-yxxNDo%YK}cX}rWhG61#J;IJ= zaBkm%<|X^2i0A3ur6IUa-Y}pouiI)1o@&TxE_Eia5e&_9@|)YtIFMC_S$FqI#0^JG zzZi_sysj2bp;z=Eujhe#rA>|_W(*C%+EIF3<@@}!53eUj_RE7aE_mk?f+-*3IooB% z@d@-!wvCYohh4F97eC*n^gsU0z$JwR<;%y(Y0i#MA%{MpuO8YKnRI(tFrI!jkai|NTz6PTwuiJs-;wR4G`95u*_*fj_To!^w%k`)+%uIJ_ z8UE}MD~`O*&!(?)qm2PSczh0GZSlW;SZjqsad79Q=11y?@VEc_@BjY#|Nj1ef9Joy zTj$Gt&qv8(h5N}#Q#?G~S6BA5yEQU-!M%s)eWJ#t z4%N;`xn&GUQTMo#5*&O!*|~61$_l^9sfDk`rD%UAr98WFu4_5F$I0c^H1$07HYFwh zWB23_V{fF~O)l|jly=AS^hh_aO<&x-zK*(((&ypzGjPLvq-Eu@N3hE<7|0=+>T!a1v%e^6fBI3$bj86~(}y!>&1J@B?`C7ks6ty;=Koz#V*P$*RI|?1(!zW6obIPZ8=p}8vJZv*LoInG@{TUy_}exN#~QOIe&tg1#y;T( zabal78DPit%z2*9xlxxy)=rIBev5sTCPvKI&0bHw0RxwEwsax6#s~v!RxwLZXMj^% zGK*JgU#$_iHl-w9kS+*oPR-uOrRynV8Mq7ked{W~fmMTcUhkGpi4jMHcJO7hBoitBs7b zC}r#)9)d+}nD0?0v*}CRy3>m6ofTTJuQ;Hc6?T@lf^%xAjA3svO3$7HSYNMcjW0$E zIq=`o{Z*;NyII4bjRGM7)-Zllp#2vG=Qu6$h5d@#@nj$M7Mb+4R2&|#Uuh|o&txTM z`H-93!RO9VV8TQN4D5f`cA`&bY&rNhXMUp2ADw#yaW6qHTu~r`nX6R!l?K-n=v!p% z{Pi1p`k!cUne~T1KLo&sd{y1q^eD1cY`=hEBiBNl+Q0puEOHF$q35EFfaum?dHkV_ZcZa(MyKsc5Jz-?3@J)Ihu(xc#E7lozv zv6evH|;4e;HYq5Xql#czwSc4BGTgczLub^jf0rRFO(hp&M0o!|<=qP0lAel#vhFP{H ztlhKcGm|y@>3zsGPNqkPkH6ziUW?Ds}@`tR4G8f^gM)L$VY`B_E+-rF{pk4)YA*_ z;Z`1&-emUWI(j9J(E&N80FkrFK2D}@rw4oHITx9uhC+W?6L;HqK63@){*BWQ}(Z@yH{&trVkLI$}MlGLLwUPNFlv4gr zSBXzn%BY@BoXvI??HDK79_}Jd+BwMAMQ(DT#9o?oc9lo$(-oySiEoIb#LjS#4p&-> z-PiV#aJr4`dhRAWR=LZN55=(#7bg!KF_D=zd6pe;Nnj z_{9L`K9L>f_l`CSfTxOnM)eT*uG4V7QUfh}G9DW=Xl5OVHdY#}ZW4$wD*`cK3BRt& z^N#$(oI3Pku+J8uWG^z8wIc@&BqR_`#s=a|`2d_N7la23194(B|GvKlSE|q_Hb8?U zo0 znEOnJGd=nBUDn#jC5i|6$dCL!&&4>Nv!|LyVM!sqCEa=Mu=lv+OB7;Q$IB$gvNeQ% zH;L!vEczcy`SWmHERRnj??L_et;8J1=2y%msI^h<|F_jIUd^1Ne>v3BKjbgx2Y zk<9OR_6t*cr(+(^hr7GzYGhAyacDYbkblg&pN2he)A78X2?6Fbw97YP*PApL1DIzz zpFYP(IyhR=En~|bXlF9WuQ*rfV8Y=L`XD!^W6W4O(!LhpFLJx3^5K6D(%Uncp=o5V z?Hn1$7j%;HoC*4xhvy@iCC5L@38#-{0Qr`qdH8pI9+EuB0P`G-s!jjNJu<=Uu~yih z&l&D~%&SlLBU#106$;RgU$=GnfRF=ZhhFDnCv&Q6eJa4^HF=2Q_nu`j&!lr@uMs7q zz4YTEy&i2^>2+PVE=6^0PfD2Qg%rnSF)5R3W~Cgp)+N7PH#xjOFe7OczOQzkA0q}$HvQkdba<4k|@S7 zdP-K2O^izr7uPr$ra3GJhbD-wU6PDr?ZtsEn^_e%jIxBD#y4;EQm=)Pwdh3IQ9VI?`XtK73WsF0-6450Gf6&dWp9i>du4m0 z=vNpdrqOXJ;U2S3JtbPqArmv5dDF2fY|Kz&RCO0jt)pV@sw;NdxuMZn6+)Y-$%ZO% z%2tgRCLLl$=pw#U3?`T{%Z{-4)e# zt8jO<3L|T%@p%BV%JeGSo=8`CunKjnGV|Jpy`a6^zugXl`wQ;VioE5`Yg zgGLDN=_8q-MZwLGNqKH3wr$J~rS;pVAsLgfV=IdG%FW2CGAG&1@((iqijKp@xSnfE4ye5W`g7zBmvJ4)bKL{1XB^yC2V$T{-Z@K}#`D7U%G8b+P*Od(n zxc{D9B==zdeGRthC@uObWydxL@jj%I{9t?O-M~)9t*(-VT!&5U!ma@UIocETqdZ~T-xC2pJz!=t0nK?;KGq7u7_L>`y(L=16Z#&R zXv^`(>J1q=t_SX%Vo!QoW_Ehg#d@XyVSMi!m2m!T-d%deDdovqdWUaymyhh1`TMR? zW=S&7kM!={{V+9wLtMTwm>EJ^X8s2f8>^hraX@mkDxVD{ljO)O*o`~0ZB6grB z`f%=gaLo(jd2Mo*us@|~1T-3YdR^)Idq<8iAQP*(-ucffHJfvS%Vs^?MrC5<`XX!@ zQHb^ma-PZ}JXp!T3mbYP>-CaBm%GTo$(?0nLu)zmKq+VEDrNo&lN_DT_3uMElsPZ| zL3iY9U!x4$Jpuc+GB-5X6ZejK!pFpH?h1E$1H*CgGIP}yhSTjIhRIRkC~n2;!+SKf zZzk$A$;7kROw3%Ii8NobGY`0yT1`G>E9VJaA>7|HN0i^YTVf}nL#(CjM<-dlxtmPB z-9rwwvnB^(lEs6oBdOR7CeA3+%*|l&+$e8uc%YY_b3GZ$M;0DvobAaPpcj5WLhl#n z$O1AUuQ!Atnd{JVrR>>hk%=2z7Y<#MiS|3WMl{bv8F`*R2XIa~QGg$_il8{mIb?Ma ze7dpDukFVER0ruZStU1W^EtYpl9cu;3BFb(a-UA~6=8Um&3v)1%u6Td)Mh-_v`(31 zKgh*?F2shpg$QiV4AIH-TD>lW`SAiQe3u~ZsfjXw0=>H&!;5bwN&ECT86D_=OLPE@ zUa!K7cS@vGC{gc&13C@}z~mi)$R5S9EGH2Di^*ef?;IVY#npf5V=Q7H-&_qoa(o-J zkvRfU2H3R9#qVS2dYwY=e`}5#+FbPKS^4oM3U!8-nY`o-nq(`~vR0v<^GgzQN|L0f zxkgrmC5s=uz)P%>B=?FVUM^Q5aIq4NhC85Xej$s^=CUrMpkCy#<>zI{UMfPlhLhawt zOnrWeLOtd_om)2)>ib`kC47KZz+Ql96B6X3w^sHflke~Eh#ogMf8{w~$!)p_SE%6Y zt3n%&?RB4%FYw|xAI923SP-1Z5N?g-_&XyB-4^gOSu?lcz6SN*(6{vqGnBvOV9hQ1 z8Ln`A^fTaCqa3W_pRJ}p>VYHKi+&3Ao^o;+hZO1-YZ64wzJtrH$%4?~w3EI_^V4xM zt_l5vEgexWUx|i=N@&QR`cGHkY9{lyQv&Jp2|&Uto{=mddqGC!YNsTG-_+vYM@i6c zOo9jR-Am3B$&!nynjE+W8W1zYfV_DIZ2L0@Z^;in?XOTz9;i^aB8xFNi7rAqr6$)o zC8s)TrPh9pNVHa3F%#q;*JQb5uEHCI5(~bNBiyURRPQd($0%WUH;}tb)?RK0BH$UF zWXAd^AAXY1Yy z^`@N)wQmaRw&xV;_3N1-IzLh7Ha#UN&61>WqE-U>$B27@M(n4l;2Fz)hduV#USN-T ze2%Wnutz)2|2|pF==?hn+r|fAKiJd28qQ44wW&Vr7wE#e%5+|%i|i3yLRa!~&S@*j z-A^`P1ZyXM@;MsnWI)_wg}OVL5Yun;R*qGuGnXsW)^xU=e$ZLE2C8JSuB$A&++D^E zR!UrLNBMljBnmK ztHZJAd78Zxy-~^E7dZ~ScaZ)8U0K_+mwRH8gx<_`er$%=Nw&7_e;G$^X5s1=%_j=D-7v$hI@Njp$o=%% z3D`jX-GSU^!8doDSnr7|4LqQs;W&2xY(kr6JtLy*uFL3Qa9@la?uSak4u(h}^Qx%~-dnlf0*r)X+ zRT`xx$m3V^>PbAWO@hR8uW;d>62ps`-gWm%+nB9O3;Xo}MYvrO(4%gpb z=_g_R^>uFp#&E2jZas8f7!~pg6`TE&CJy6ILBX) zO_1dmQe^(ec-gr-Nm_5#irEV?1>=;M+nBv?85+;!!+-;tO#(Oka*;0#>ZCTU)VSuGI`{?z|Q|1`m@=y*lS{3Sv zt?11qlfRDhMh;m^>vd#M|4EW{os;EeH4XXqBw1GX4+-0!C=E0Y7`B+_8@Bd%)RTKk zGL5|(Fb{wnW8Mw!0du(q()%OQA`sql*w3+BgExBveLp#{fKkvu89iu_hzZGikS#M*w0a?XQFs> z&z@YOmHwR^Fgcf=hfzw@e`OC%7iJiQsxbOT04^j1BDr%AmTwQj`z<`1XvBSMH7zbL z*P^Bw^P2eFT>Hv>W3mP#V+;u3XZo97YT;*ky`KK#RXKE(Db$Jl3|m|j>VenDesV2l z#Yc1yFh8DeY!^;cok*$}3tI6~p?zNCy|5BMdXaXYd(K|Ms{>1(TI7Qy= z*2VAg*_{3|=TPjN#rn@h@{C@V;-oE;>L2Mri=fBNoF3Lk`6!!WAr0vHy4l1X?T3e= z7X52;m~X3eX)O8V5U=RmVA6-;%n%)HbLbsw-c(%X{*YJ9an>ye#aI5GKPTm*@>@qK z@F^mOWRyA`F#k= zn~_^Qz&vYbE4g#ER9-)EgH1^YB3oqOMpNbm&#)4;S(!Zi#5~_sA<(LHh})TmgZ0{w z(=C;YeO&o>55=w3{QPb5v1vj_$)(rq20fA&28AMo{LW0Pd|VjVMzlFUWl!mNY@ZQ| zKi26mmfzpIy_M{#&D_L{{WF*`n~$4;?WO0WN=aMJ+*scbyxfz42SW?kci3KP-~B1$quenp zAQajytG|x`QluiYx z_D@TBv!zV#UUNex_tuqnbeJ2P2bZty#4n~)UM(WOc_b9>>oZUiTL8n`Hj=rhR1Pyo z_zZbK$8sHNt)X*wcMJKZG>WDB1ZFRWV*fgFdDRQhq*rsf)3QqX)5{i5zBT$jxzX|D zJ-@e-4%^CQTO)VmKc?rg7kQ<}c^G%Cl~f)tku<#vR+3xP|J0$$bzaXAE#zxdg+w3Y z_2K>9-IKY%Va!M>q&M)FD!E$U4Qbm$(cl?5xVCxB=V>879xHeb#(wi|p)gZt;6hnG z!h+h0KkLeiCb_{jC=^Qzb+|-NVsa-7c@bJF)A-!FaBVi1&xs$setU;n$evlH67|Lv z3x8v-^xv#`{*ecJuXb{O2%k4z=Zk$p(cDjmUZa_lJE6IF`d3PmnJ&otH57GvGgtSo zeDoyOIX(HO^me0va2oT?2V`I`dBa`{n$a^;BHQM><3MZfOCRYF@HQWdhFQvc@@1cr z-Ep!uuTQEDYmNEnIG*31_f3WkoPZDSLZJMl9`0%D!IZpowv+aEH&o$5(Qf zpRA;k{GiuS=0X2Xj&*eg@^~HElILAfy-HdIx#CZr6%9{kem(2DCFp6jEFvYO|CFK56!z<*xmn(bw z$V(~v^fKc5U^ zD_L-;Qqmi`Lwg_uU!Uo4rF%X`S+tRx4S&e_!){2~Ob&5eIu`8U@44DReDg~sw9pN| ztqI1{Z{#{T9(KIfM&8dV6RTEkyjP)k#_KaCyZ}d-PyNfy3VCpp`R}Vj;a!9K6LQwG zw=@=+`%|9noq*(Y=A?6++&48J6Tdc<5b~JK`qA6lj``6CbZCBw-q+<2gy@h1we3y}pT+xSIw)(LSi=WdI+PJj@fBGpsFS@~b96gnsrw+7Y zj?=0*(bG?Nn|uoBt$Q~r8?{1>%qobKSBGs;*OMN=iwP+2OP^o_y?ftI%ChxzX*0KU z!TJRBbSk6CzSZNk;482Q%91}_Krqt-ogF&nZmZGjP&PsB)@NzA=Hy@7q6{Qar)%Dt_^ z+T$m zvKBL@PTA8-@6Qa*L}WB$e)oAJ5{5^URk26hC1!QzkvIIFg^f`r6wE&%zc;qUYkxnq zp?`Dm*lY~(HPMM2D|3F>ApV>$x-8P*9M`i?xo)&{j+OLjHn3U8vjhH~#tZrVmquhv zBRliS8tuu+ZnoB-n?*Jzg_)o)h$X*l&)zM1+{PwC9`NtA&V*gHnOEDw78`E)qUKxr z^_V04Jlx1W_7h^A&ihCnP|JMV4M&*=-Q9%m^u!&e$Fp;cANp@6hedwF+fJblJ)a<6 z;kMXr>5Eh3w(d4z4s|yZq;a&=)Y@U}6@RQrqc?L;7NXu5@nzOAiQ7a^Ty^S;tD=1r(bd+dwDN%7tzcJuL;McK~r+RgZH+%bn%DP5;`cB(f=^igmujIem0la;W+)3JvFG%XVH~oV#Y+Yy!Exk!@54u zmeFf@F$?pXnvmNqQc|+XSVj9_O>839{n>bU+K6H4vC@Fa)wjMN=z1OJ!gsShNe>j(0uf0z(|EI|tD*kjlfU*z%c z`)BPO{5#f!&<@dZj^E#Zf#W23-fk!8)#Y>8NEs&!_*`w;&F}L%4Dt9c&zgMe&Uo3~ z#)e)Te|#O6fbHG+d9IppGBsM>IN37a#1CW0^O~me{S7wZ{^2NTV`jr_4qv=ln}9<# zaxf`}UeP{rqF!u^zgzlZ9?$3c)*wghVZ^DdXmKQmK4*tNoUbH6YskW)eI_W6B*>w6 zT_0%;`=bZ@V@d$?vLgW%x;P{APpNPkhPPCSqn_ zHj3XHu_h=+4viwWUW4O&3g;J&Z(CCT|NV^fe{3DN*U~CIa8prQNX!_g)CHl=>BI8U zGoCba-qWKhJ#NGKbj3u4Zlm{{^oz|-rCn^kGCj6MaN71iU#D9-P1QZC`OW!9N<@0j z=vB_6A8b!g+-{wI?(GgI|E7(dtM5s3-k4~WzOb~hbHl^!(yiz1PT!Ms$EkPht+YW? zR-_mD9!RToe$=4y+E(eB&8yQ*Rnh62<|Iisez_MX%Z3LDa>`sQ(f`JabHjL9;=*TV zCiA3w#misr$>N!wC~ar4W-&EZtY5{+t;wvb&}VyiTat`4Pm~z;jxHILEUj7hJ^V;3 zE!w1r`ec%Xm&Qu%^BOVtp?}~}igZ20Il?Jfj?l}P$KKcc(Mj^;gI0EJ)X0!Dd(`5& zvWj)$&sGj_Tx*Z%kL=NLs{@{Grz^lmg%4j@&u+%LaXd2z-5v1ip*>*ffOokn^ir#! zIH_b7HGiI7fyO;m_&HpODJu3v-e+HJq&*hsc#a)J?s1L^s~f3sfc5#@mG&^>*@1!o zO(!0pL|Kaxm z*x8il**pXJRG)o~O@gpy66@Hk^?O;f{(nCZgP#Q;BR&8I6KmTGSp%CEgdxuZutY;9 z(uU^)|M;Vc1j6dGKay?+U=n}-71k0C_n>d!8}lc~3_nz9Fe!~==1483AJ<~|Ff9&r zWNt?X*6W`!k6Nci!l)z^E}{qEr3U`f=-~0-dA73#<0~{+#53tg2Ra;j(%+M=g<=MM z*!;cScwXI@XEgOvHHg}##lyzzC+5#?8lnLX(%Be9SH=K3f>-iFsNwE2MdIT+8H+Rwk~rB3I&JI8?Q`8kMV-7jtw>ukkv+DGITC z=GV8EIZ7LuMdN+WC6!p@E9H+<4sxrTqm=zr$|&Eiq8Qv&j1G=sJEezw$?YnqqwOX9 zjICVn)msj>u$QG5nXB8Oy`*%v5vxN=IX2c-e6OgOziuxf?dfkkY=)+{E2VBbGdK@4 ziG5I|9I`OU!lMeLvQF&!O2KuN0#j}1q+eAbdlpn1ABQOfM?O$>+$QPH@=?qfZ{3LF|#J1{209e zA3X5uH}X^8=$YHdI)4*S*04Qs@-GjJ9>5-XGFF8TJ=ovF9P0fO(Cu#zSd(p3O`@mn zEzbyM@a*>T1oXP^fyh+;8J)ba=CTK3i#_nUS{Tm140v7z4(OPndN}fxw z)?GeM4<|AJs$F`_Q1Cp*s7FCfy5B4_;d3+-H8<;_cW0eEUys9{dYZ3=!n|gHbm5KiP3}*PUE~d;t=>$3#SL)#q$9`Hba$UXk7@R@x#2MyAP1fW7YCY0T z%;Y`F%<4^gtlP@-nbC##I;0RD=7p%bT8Q2{@=teouHB>%ezObk-oTs%o>eIKk(D@4 zo+`V5{RV|dj4yyW&v<@V@q8tj4mh4;+;u60B7_;2WEe8Hk=0^PY{N{Rb2MO0zkvCL zEei22x)3k76yomW*AqOq?qe$pGVR5GPJ5|t<0$ikI!mhyw$fQ_ z<>OXsW?pm@(-d2|+m$X}AF?W=QjA7adkg-Earl_j@PVZ&1p@SB`Sj z&`s*S?kcX#b?_~$jB>@?C@Yp5B`&BM8hlkCd7=X2=yzCFsldfd{@fP@ zdS0)R1y8D>wqKRpyQ;urf0G2|Gq19`N%F>#AxTsq#-9J1`7?_iC}78Pl_RW41^+Ng zi+qz{0yEw0s=@cW0=?cUkl48z4nOC6Gn?mg*@iIEKi&t>51Eg^dl`M2ie36^MxNUps270|8~6^f4)9_@I98Au zJ~%53lYZyB!}rQm%>Ht+l2=wT7siX{Nc_s_Mn~#d=7sQmHfzSd^vE#yC(+r+Gt#>J za}`#4c=3JOxre@&s7$5;y}4wET^;G^C}b^XND=2?GKdN~xds-( z@+8ko=M`Zk-z%@m0(?15#&;9_jw|WMn#$bGxrOL-oDN58x)+xfVm{y1@iBCv@Ew}B zoea|gx@~F}p@e67mI?GZ7V`buRD>O+1u%Xo;JT#{-|k*_o|bW9VBO&6=@uR8JHHun zByC_F!@y~c&ZgH-YOA}kC&Ot(<&pHt`EI(XBMRpX|L}DEb?5Z>8iSqoZg1q=t;Q!O zyFT8RzFpYoJbPtWTD$Ci>FdAkciQ}_{F2uYf9KYk>gfYJ9Zox%G%9`D=OMq*VOs9`y%hOmf+|`O< zxmJ`#@nTMI;~!5GWNPa;$@q{UpRQ=6-h7P&ZcP#U+wl?_c}hA}Xl0)&LGJuZ-%@_E zlov3Un!Ph``y|Pmg^4nL(kV&oLD%C&t!xX^%9bq&($$6T?!)8I6JTp#DP5(_L$YL>``sBBWCwf@f?(H@N`Gy zUsED^x&!)hU3sFw5&r&kh_|MTX}3T0y~r=-kuhu&gmwGrA9=})XtFqwYq^fQ#@-dy zLSB0DpDxV53}7a7EL~E+(A6}NEaYm|Nw~+D7{T+a!Ss`5(B;&EXKZ5v@k$+p20sH3 zcZJ>;{_N`kK}g`*v-NWJyIc;y7p_T9dj()@IrGWP=mFU1Q*yrbwgfXA#h>Fu-V>vm;Yz0P6=UG;L>ENo%bJ3YvtaRbm5G_{h zC(~HWUX~rq)vL`MJDzblMY7+`itD{o^fYp<_heBH(rfbE($|1a^$hss9na?avqyNm z0opuf@m(d zfXnC~K&J5xbB#V{Ad+Lzu}*q4I8=y=TFmL3S%~S&3sKXO^LWD|EX%Qz_AQn2u)n<= zZrELJj$XoRBBNy|>)UpfgkpPH^Q61ny5cCNFZSYc$Bb^@>WF_qZ{-=2jH;`ELyS>I zWqBd~E`3rzJ>WFJ3#I2gVKjK6zkfJ;%EM97Cmi+2HvU*kkMCkKbBF249YIcJeI}Ov zP39r+GSubt^rjVI4zG>#u0k}NRES*xMRb;a!WHMPQvbfa?7Q7v+?V#0_j#R}wc1r~ znbSF_GsEOo3j8FCdh;yvmFJKR`Rs`V_6amN?1=~?Gudi+B4v%||EwqNC(=t?7KUw) z>Hj)MkEKmG{^VL~ds-&04x$@)K_*OOL_V>P_H$+der*WxS9aFY3$L&uxpw0Pmm9WQ(=;XLk1 zk7Ylys1rO9Jv$6_GU=_H5QZ6Ck7gBx<4d=7IL32?iL{ROd(o36~LmGqbwZMLzb;j%IBdyrCWQI94c^>plCCEI&X%BE33q& zhee1CaaiFUgLfk!}=NjXMjTbaM*%QHgbbV78mLn9cG+~IC8itnlxfa+> z|M6%&ZXBi)jnB~F1DP;O)nkV_9hzLD_Bu;0mupKK&X?KkituByMsD~g%Rez>2cxud zwMr{RZ8VaT$Ns`oDkRrdA*Glsn4c2;*Q&68FkQ9Z$;5>PVdH`TWVH-Lg9m}=dWXGq z9B&rQ(V+JS4K{bz!d=K2jLpT~rUs1OnFEVw20Ru6{$SSg;Qh>2G$_=I9L&@jo~5g1 zk}bH){`iZ@ViTP#O~^C;Rlw}deTg!5kVc{xtMKv^^QNb&pdP0}&N=ezI(t+MCF?Md zJ?%RKvGx%A6ggghnoaIuJe{;@T2ww~AK`2*R<9;+N#-E?qyZDi$VK)sVD)ALT@tyN zP@Ic-%uoL5&A#_Ug}Q^cnfd^|Tb|6!w5^#eNzCbVd7+`_kB-K*%(k$Mmkq3WDF5>f zdO2ckA$u&JaGtBdyyp_KohkG&HV#6@D7vI}1R`%~AY6arp8T5@rCA);pR;eVDL>m` zEjraP!0JX0mT^qA=)$~%6S+Jmp*N`;U6BVA>QW7Jo<}gZlZ?v6(PnDr2T8K!c#1gC z1GeifKMUPo+nrLSTYdJIrZU5VETf!bmgzrTQ17@BBAvDHeqGx4H4#$44O8i`ES$VGb5?%i=fljZgZYp+CDi3&r>fNuQ| zh!LEFZ8#SnUlE8uKL(com=O&fR`xpaV zA)HI@(2bv9)FrlCD}@Ur9xfN*-Y&->y#AqN|Zo)CEQIKDXW<%zL6UFP0Jcn zA9|dt+2imlB?kSfL{2Le`p*c$x2J)a9~ubH1_7w;69|=65Dc!&)=;tEfKJan%gLqK zlCNCPet@?I*w!+j*Ec#V`FUEPE*=90JneY85Jq|P|LOR#L z_um)5n|sSnYYNd+$YR1=3e^M5%SaAr!I*s!m;6;zZ!hRIy>q3$zEE2c9g<3-DO9E z-qORri~JR-z=SIbx&X*DZdc&I0)DQm3iP$|f_^AJ2j{L|!kJ&3=??#|^yzcoq&fhVTb zqLVR%{iS&xnAC6*qBwV*`N{mxap5p8q4WL#uhn(t8*)xJ>z0X+LF6m>&mZU6yReqr z`QReFp2of@&SAHovuBDuR9kJyq6T-BX=7C4b=E;f`1F(-t8HXVGe`E7SBD3x;csSx zA6Q|AR*TGV@Od@V;~sS1HV;%+dm`tm2mZZCmT-nARt^qFx3Szex`$z+MK~s&V_zJ3 z)CqMnv27?_zB}}oevb8#0zI}Bb8l9`9?5fs_|$`Sg^WVjb)bKFD*cSryGaX=E)u45 z6zO0mbFV7pX-)PU|6!8Sbw;sfy{pwe_VdOX#lS2Dmt0Sn|HdA{treY`#+!?C&sGs|n~@#4517i+Ok?tmUieKWCwpRLBbLiEVwzV2Wl z0QR)yvVUP5uUYpLX>OG$JsxXic#uY>o{N`X_oawW8SBWLC*+a}Z(led;krFt4oXD! z3qnMTAS_goq2@b3c5x8Cer26FgEdypTb8f2_)PDMYYcnJxi0oGvOi~C4)mMJr1i^% zc~%b27BT0UoZj^qh1&3t%<_E`_mXC6S7s`2*qKOvIzjquO%lI#$)ao>FLPKoAGnog ztx6TP=5o*SL50Eh9Z^1BiRnQB+=BL+B`Ub#rWB_(?|4T7=~)U$STj{Pl3 zMm*69GqA+%Sd#QVn8;i*tz6&hfRNYh3#j1UYAmnQXFIfAt;C&QgRuJmJ&^%q81InT z1LyfHj@6D@6#mqr!vrmQ$I|Kkl>3rxNoc;!z+S8zSo5E8uUIoK%f({ypWiCTo7083 z;G04nd`O|zJW;4KACW2ioFpDONz!HZDM@XYET^NAq_TdpqzrSw-JvS1w@@LE=L$c| z>C)}tz#K9<2jjSZ;vQ{udLT*z1Mwm}2)4g#@!U;|9sEk2lLWiANm%qvgRu(kUFMLd zTw_4kW4hpbaZY8Q{kVk+bus-xy{nt4eYwtX{Hai)aIw8 z`MVVP(998%2n6G5t*aic$iwziJ&-tqn`~AlmkQiWq8GXyKrxa>svO-<9m|ovA3UvbK z_?u@E#r#T=MAJv{&@5Sc=f=vx1xeDOM^{Yb^BZi=41?=R`2Ix~gtrQF`UIivSgv`h zabL@G2+N`X4CX#m-+-A+g&G`vNG|`a1~a%mn^Zt9wnh%>{KNd~Xl6_Y(7${>2k-V7 z@E7OuK=uZ#B8O^|&;QLizUm$S`G5M#7Cmn*_7&waVuTw`HVDNDwGIa&3g{?qCD)ez zkf(tzm~P2hFnO-Y|B@@LYc78=hp1W<^MxPKi+4N&Jx7o?iEbo0&de8X=8CbAA!J`O zaC;v6v(?RIZQJiMYqC2ED?_nlw+_~!1yCMpB^}j2rA0&XJAVYjvXLHBg2^RqvXqxe z6%s#^yxW;z6fM=^tu7z?+gQrR=H;UL;DT~Z2u>NvLv7DTMvFG`g88r?tlhD5YzT6X zq$BG&y<->2VKF<&a=Hq!Q3(09z zB4NzoJuoce||B!o)w{Zl*pXu0r{A@ubo)d{V9Q?-B3qIo@>Z| zc_aB~f7(KpEGw0+aV~Uev5$BP^II3^BmFtKysKpr)R7*{k>n!l>oD#*J$H!>rN@zP zGStTv_lI-un5V-$a#(F=TgkVRrF1>g)7LD7``rv2<8>aHMGh#aLi&}v0)3b-Jd=LC zsQ|nM@z(ieTo|4zkeUeTxFjENLeT&VQFVyl&6UL!g?Q0q@uOSZ&`*Iu9-r zgP!+yZWxvXWx#wHIacrXqT5j^*QU_-Ff0U$_UzvxzxF8JLUu)zNbxZ~hi^l0X@5GN zEg_$k+C+-7OJuph1?`JMaFw-7wH@!TzP&h1E|;e*-SA^}DBh97ayZKSmEM9GVL#=8 zxMGe)DB>!0C>>USX!;h-pH)ixTJ%-FBe(040ayP1?|)fJ{nmUh_<7uHLa{iPT%J=t z4)wE;9hK#xadE|XK8H?&=-KQ+FXXOvQnvPo_%a84RCU&CU+It?mXEY|%_M~U;Q56v z5Z=e9yuZ&j@OiLmD?WcPHz3socdCN1^q~%p6?x1MpvRLr@2Y(Mp4lNlFu6;I0z6&Y zLh5uV72O9n%#0?Nx`!1X3xFTZ% z{eyfCTb$0v)B7D{pl6wc@V)a42*J%T9o;G9XX`hYYOl&<8M)56iHT!)fc`LJkW zA>a4?l;cZW*%uswu1Y?K76nL2wGe~%cTs$!kCohavspUyO=E6*{T5Q$ieAwHE*QZ3 zHK1Dt8u2;#`pimBxK&6QbFuX!L-5ujgSo&3xX4`fho0Z%Qw=wGKMg@oa^-0?3-Gpc zGx=n!l;~|PxXE!TEmnsNa+JSaYfBGysf7IMib8UW4?B=6pH83b*iJI`LaF#H8;6rK zLNSz_=E)j719)~qru*Ar@2d@H=a`7ef%NE2GU4FESb0=rjn-#;;Ow4={+`Th&LU5@ zHd5{_vO%99AFd@5(6b#KJ>>rU_eDuI`KBw|0}&dZh;a$oP`oi>L&OPb{mmY$-;m2= zO?HfT7B21~514yGjt{iO8s?b}dY6Dfi?b1Nk(}L}IH~EuTwQW`_y3AV6LM!~4w|r| zUbLjA*kPQjAN#`-Vc8)Y!Do#~nHVW5yduZLtrsdnBS(em1ipjr7YzNl!}~^e|(d^5uB^z9$>Qt{GAB zYmBT2vBu0dKDb|*fZxwQ#5?kaj-~O^ z9C@xWEy*R#GGcgmtUQjl#l|{*So1Ie`+AcznruXmFDGT_7v^8jA=h&-0aq?$VIV)x zP48oJ|FjK8P4ht+xzSNKbKpTfD`z|NyZ4bdyvbbMA@pYYXW`Hh6FR%c$mh@2^c4DI zbO?J4BeM|9>pbvYv@F=h`+Lt1e|od#{UjTg_Lx|kkCA(scDQ?B12RGq@xYC|LVFYL zS;a^n7hCk1v;ptVCh(jm3tPLN_-pTqQ%)kCCM#9Riah>M? zD|{2sdVLl;yfWhBwP@)|o^<Ybw8KeRLbunWRGvFnC!*$tEGRyZ zd&-KHLvNWAO>U&eUkUiUnf&QE6VmEOi4F6VBZiVMo1K7vR%bEm*8~r8ZSKtJzOdE@ zwO1#gY%;x&{BzGFMN0v>zp_()XwokcK7RC1)ns3=f&5^o4bM(|@R*!b5qY#b+nB#R zGD=E%vX^ra^K*-t4a&dQkLyNQ^d+Zx$QC;m`XN3#f%~K!JRV@g_c~FM;bI5x&i+`$ z>lwI+Tw9J2-c#eGjDPOC{0(@0Gy#EmS?m#IZuR;Y+4jN)2J&AIxqmv?HwTJcMs$)` z8A@*SSdkBVM-otDeGX=?Gor)2C>fSwgJXkykvKIG?!J7^la1KZ>$ps!7xLaLKinM2 z=Qfet-$WC(I7N!jB0Dth=8qC`m&xS&tfI+#21LrY-)%6kg+D(1O5dn18|$B$aEhML zPxL}Q*hSysjRagP&qCwlCcKywCGY9WdvMAZ6IJAJBgujCd2<>RCy&nAqEYY$JpUts zPM0iP{l$c3+DNIk+ZKDmeKF0FT%dVMW zlB1lH>WkD93Cxt`bIa$g7yIqPnRo2;m3hs)?{n^v=lyQN(LbZ*G(Cgvdwkj3oQOT- z?0&R0K|4KG_8M%+j_~^LOhCJJ~esvegDX&-uX1kbwLHe6I4C zul+butnS(%uFxMotrF3b?{9;P^j#X`Wbj+wuUKE`cpYk!v!2nCwZ;e0;>PjZa{LAq z%}>Pkt64bw$%wS%XsK&qi~5QFP~Ru#+lKkS_UN_Hhpy~+j!juGe{94vn^^hT(iUc~{or#V5g)r}all(FLERR,"Illegal fix langevin command"); iarg += 2; + } else if (strcmp(arg[iarg],"halfstep") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); + if (gjfflag == 0) error->all(FLERR,"GJF must be set"); + if (tallyflag == 0) error->warning(FLERR,"Careful, tally is untested"); + if (strcmp(arg[iarg+1],"no") == 0) hsflag = 0; + else if (strcmp(arg[iarg+1],"yes") == 0) hsflag = 1; + else error->all(FLERR,"Illegal fix langevin command"); + iarg += 2; } else error->all(FLERR,"Illegal fix langevin command"); } @@ -155,6 +164,8 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : flangevin = NULL; flangevin_allocated = 0; franprev = NULL; + wildcard = NULL; + lv = NULL; tforce = NULL; maxatom1 = maxatom2 = 0; @@ -163,6 +174,12 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { + int mem = 6*atom->nmax*sizeof(double); + if (hsflag) mem += 3*atom->nmax*sizeof(double); + + comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); + comm->maxexchange_fix += MAX(1000, mem); + nvalues = 3; grow_arrays(atom->nmax); atom->add_callback(0); @@ -174,6 +191,14 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : franprev[i][0] = 0.0; franprev[i][1] = 0.0; franprev[i][2] = 0.0; + wildcard[i][0] = 0.0; + wildcard[i][1] = 0.0; + wildcard[i][2] = 0.0; + if (hsflag) { + lv[i][0] = 0.0; + lv[i][1] = 0.0; + lv[i][2] = 0.0; + } } } @@ -196,6 +221,8 @@ FixLangevin::~FixLangevin() if (gjfflag) { memory->destroy(franprev); + memory->destroy(wildcard); + if (hsflag) memory->destroy(lv); atom->delete_callback(id,0); } } @@ -205,6 +232,8 @@ FixLangevin::~FixLangevin() int FixLangevin::setmask() { int mask = 0; + //if (gjfflag) mask |= INITIAL_INTEGRATE; + if (gjfflag) mask |= POST_INTEGRATE; mask |= POST_FORCE; mask |= POST_FORCE_RESPA; mask |= END_OF_STEP; @@ -260,13 +289,11 @@ void FixLangevin::init() error->one(FLERR,"Fix langevin angmom requires extended particles"); } - // set force prefactors - if (!atom->rmass) { for (int i = 1; i <= atom->ntypes; i++) { gfactor1[i] = -atom->mass[i] / t_period / force->ftm2v; gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / + sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / force->ftm2v; gfactor1[i] *= 1.0/ratio[i]; gfactor2[i] *= 1.0/sqrt(ratio[i]); @@ -279,7 +306,7 @@ void FixLangevin::init() if (strstr(update->integrate_style,"respa")) nlevels_respa = ((Respa *) update->integrate)->nlevels; - if (gjfflag) gjffac = 1.0/(1.0+update->dt/2.0/t_period); + if (gjfflag) gjffac = 1.0/sqrt(1.0+update->dt/2.0/t_period); } @@ -294,6 +321,94 @@ void FixLangevin::setup(int vflag) post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); } + if (gjfflag && hsflag) { + + double dt = update->dt; + + // update v of atoms in group + + double **v = atom->v; + double *rmass = atom->rmass; + int *type = atom->type; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double boltz = force->boltz; + double mvv2e = force->mvv2e; + double ftm2v = force->ftm2v; + + double gamma2; + + for (int i = 0; i < nlocal; i++) { + if (rmass) { + gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; + gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; + } else { + gamma2 = gfactor2[type[i]] * tsqrt; + } + + franprev[i][0] = gamma2*random->gaussian(); + franprev[i][1] = gamma2*random->gaussian(); + franprev[i][2] = gamma2*random->gaussian(); + wildcard[i][0] = v[i][0]; + wildcard[i][1] = v[i][1]; + wildcard[i][2] = v[i][2]; + } + } +} + +/* ---------------------------------------------------------------------- + allow for both per-type and per-atom mass +------------------------------------------------------------------------- */ + +void FixLangevin::post_integrate() +{ + double dtfm; + double dt = update->dt; + double dtf = 0.5 * dt * force->ftm2v; + + // update v of atoms in group + + double **x = atom->x; + double **v = atom->v; + double **f = atom->f; + double *rmass = atom->rmass; + double *mass = atom->mass; + int *type = atom->type; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + if (rmass) { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = dtf / rmass[i]; + x[i][0] += -dt * v[i][0]; + x[i][1] += -dt * v[i][1]; + x[i][2] += -dt * v[i][2]; + v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); + v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); + v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + x[i][0] += gjffac * dt * v[i][0]; + x[i][1] += gjffac * dt * v[i][1]; + x[i][2] += gjffac * dt * v[i][2]; + } + + } else { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = dtf / mass[type[i]]; + x[i][0] += -dt * v[i][0]; + x[i][1] += -dt * v[i][1]; + x[i][2] += -dt * v[i][2]; + v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); + v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); + v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + x[i][0] += gjffac * dt * v[i][0]; + x[i][1] += gjffac * dt * v[i][1]; + x[i][2] += gjffac * dt * v[i][2]; + } + } } /* ---------------------------------------------------------------------- */ @@ -490,9 +605,8 @@ void FixLangevin::post_force_untemplated // sum random force over all atoms in group // subtract sum/count from each atom in group - double fdrag[3],fran[3],fsum[3],fsumall[3]; + double fdrag[3],fran[3],fsum[3],fsumall[3], rantemp[3]; bigint count; - double fswap; double boltz = force->boltz; double dt = update->dt; @@ -526,7 +640,7 @@ void FixLangevin::post_force_untemplated if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - gamma2 = sqrt(rmass[i]) * sqrt(24.0*boltz/t_period/dt/mvv2e) / ftm2v; + gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; gamma1 *= 1.0/ratio[type[i]]; gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; } else { @@ -534,9 +648,9 @@ void FixLangevin::post_force_untemplated gamma2 = gfactor2[type[i]] * tsqrt; } - fran[0] = gamma2*(random->uniform()-0.5); - fran[1] = gamma2*(random->uniform()-0.5); - fran[2] = gamma2*(random->uniform()-0.5); + fran[0] = gamma2*random->gaussian(); + fran[1] = gamma2*random->gaussian(); + fran[2] = gamma2*random->gaussian(); if (Tp_BIAS) { temperature->remove_bias(i,v[i]); @@ -554,25 +668,20 @@ void FixLangevin::post_force_untemplated } if (Tp_GJF) { - fswap = 0.5*(fran[0]+franprev[i][0]); - franprev[i][0] = fran[0]; - fran[0] = fswap; - fswap = 0.5*(fran[1]+franprev[i][1]); - franprev[i][1] = fran[1]; - fran[1] = fswap; - fswap = 0.5*(fran[2]+franprev[i][2]); - franprev[i][2] = fran[2]; - fran[2] = fswap; + wildcard[i][0] = f[i][0]; + wildcard[i][1] = f[i][1]; + wildcard[i][2] = f[i][2]; - fdrag[0] *= gjffac; - fdrag[1] *= gjffac; - fdrag[2] *= gjffac; - fran[0] *= gjffac; - fran[1] *= gjffac; - fran[2] *= gjffac; - f[i][0] *= gjffac; - f[i][1] *= gjffac; - f[i][2] *= gjffac; + rantemp[0] = fran[0]; + rantemp[1] = fran[1]; + rantemp[2] = fran[2]; + fran[0] = franprev[i][0]; + fran[1] = franprev[i][1]; + fran[2] = franprev[i][2]; + + fdrag[0] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; + fdrag[1] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; + fdrag[2] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; } f[i][0] += fdrag[0] + fran[0]; @@ -580,6 +689,11 @@ void FixLangevin::post_force_untemplated f[i][2] += fdrag[2] + fran[2]; if (Tp_TALLY) { + if (Tp_GJF){ + fdrag[0] = gamma1*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*v[i][2]; + } flangevin[i][0] = fdrag[0] + fran[0]; flangevin[i][1] = fdrag[1] + fran[1]; flangevin[i][2] = fdrag[2] + fran[2]; @@ -590,6 +704,19 @@ void FixLangevin::post_force_untemplated fsum[1] += fran[1]; fsum[2] += fran[2]; } + + if (Tp_GJF) + { + franprev[i][0] = rantemp[0]; + franprev[i][1] = rantemp[1]; + franprev[i][2] = rantemp[2]; + + if (hsflag){ + lv[i][0] = v[i][0]; + lv[i][1] = v[i][1]; + lv[i][2] = v[i][2]; + } + } } } @@ -649,9 +776,9 @@ void FixLangevin::compute_target() input->variable->compute_atom(tvar,igroup,tforce,1,0); for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - if (tforce[i] < 0.0) - error->one(FLERR, - "Fix langevin variable returned negative temperature"); + if (tforce[i] < 0.0) + error->one(FLERR, + "Fix langevin variable returned negative temperature"); } modify->addstep_compute(update->ntimestep + 1); } @@ -764,20 +891,41 @@ void FixLangevin::angmom_thermostat() void FixLangevin::end_of_step() { - if (!tallyflag) return; + if (!tallyflag && !gjfflag) return; double **v = atom->v; + double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; energy_onestep = 0.0; - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) - energy_onestep += flangevin[i][0]*v[i][0] + flangevin[i][1]*v[i][1] + - flangevin[i][2]*v[i][2]; - - energy += energy_onestep*update->dt; + if (mask[i] & groupbit) { + if (gjfflag){ + f[i][0] = wildcard[i][0]; + f[i][1] = wildcard[i][1]; + f[i][2] = wildcard[i][2]; + wildcard[i][0] = v[i][0]; + wildcard[i][1] = v[i][1]; + wildcard[i][2] = v[i][2]; + if (hsflag){ + v[i][0] = lv[i][0]; + v[i][1] = lv[i][1]; + v[i][2] = lv[i][2]; + } + } + if (tallyflag && hsflag){ + energy_onestep += gjffac*(flangevin[i][0] * lv[i][0] + + flangevin[i][1] * lv[i][1] + flangevin[i][2] * lv[i][2]); + } + else if (tallyflag){ + energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + + flangevin[i][2] * v[i][2]; + } + } + if (tallyflag) { + energy += energy_onestep * update->dt; + } } /* ---------------------------------------------------------------------- */ @@ -877,7 +1025,8 @@ void *FixLangevin::extract(const char *str, int &dim) double FixLangevin::memory_usage() { double bytes = 0.0; - if (gjfflag) bytes += atom->nmax*3 * sizeof(double); + if (gjfflag) bytes += atom->nmax*3*2 * sizeof(double); + if (gjfflag) if (hsflag) bytes += atom->nmax*3 * sizeof(double); if (tallyflag) bytes += atom->nmax*3 * sizeof(double); if (tforce) bytes += atom->nmax * sizeof(double); return bytes; @@ -890,6 +1039,8 @@ double FixLangevin::memory_usage() void FixLangevin::grow_arrays(int nmax) { memory->grow(franprev,nmax,3,"fix_langevin:franprev"); + memory->grow(wildcard,nmax,3,"fix_langevin:wildcard"); + if (hsflag) memory->grow(lv,nmax,3,"fix_langevin:lv"); } /* ---------------------------------------------------------------------- @@ -898,8 +1049,17 @@ void FixLangevin::grow_arrays(int nmax) void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) { - for (int m = 0; m < nvalues; m++) - franprev[j][m] = franprev[i][m]; + franprev[j][0] = franprev[i][0]; + franprev[j][1] = franprev[i][1]; + franprev[j][2] = franprev[i][2]; + wildcard[j][0] = wildcard[i][0]; + wildcard[j][1] = wildcard[i][1]; + wildcard[j][2] = wildcard[i][2]; + if (hsflag) { + lv[j][0] = lv[i][0]; + lv[j][1] = lv[i][1]; + lv[j][2] = lv[i][2]; + } } /* ---------------------------------------------------------------------- @@ -908,8 +1068,19 @@ void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) int FixLangevin::pack_exchange(int i, double *buf) { - for (int m = 0; m < nvalues; m++) buf[m] = franprev[i][m]; - return nvalues; + int n = 0; + buf[n++] = franprev[i][0]; + buf[n++] = franprev[i][1]; + buf[n++] = franprev[i][2]; + buf[n++] = wildcard[i][0]; + buf[n++] = wildcard[i][1]; + buf[n++] = wildcard[i][2]; + if (hsflag){ + buf[n++] = lv[i][0]; + buf[n++] = lv[i][1]; + buf[n++] = lv[i][2]; + } + return n; } /* ---------------------------------------------------------------------- @@ -918,6 +1089,17 @@ int FixLangevin::pack_exchange(int i, double *buf) int FixLangevin::unpack_exchange(int nlocal, double *buf) { - for (int m = 0; m < nvalues; m++) franprev[nlocal][m] = buf[m]; - return nvalues; + int n = 0; + franprev[nlocal][0] = buf[n++]; + franprev[nlocal][1] = buf[n++]; + franprev[nlocal][2] = buf[n++]; + wildcard[nlocal][0] = buf[n++]; + wildcard[nlocal][1] = buf[n++]; + wildcard[nlocal][2] = buf[n++]; + if (hsflag){ + lv[nlocal][0] = buf[n++]; + lv[nlocal][1] = buf[n++]; + lv[nlocal][2] = buf[n++]; + } + return n; } diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 2883ac9ea2..70fb254f4e 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -31,6 +31,8 @@ class FixLangevin : public Fix { int setmask(); void init(); void setup(int); + //virtual void initial_integrate(int); + virtual void post_integrate(); virtual void post_force(int); void post_force_respa(int, int, int); virtual void end_of_step(); @@ -46,7 +48,7 @@ class FixLangevin : public Fix { int unpack_exchange(int, double *); protected: - int gjfflag,oflag,tallyflag,zeroflag,tbiasflag; + int gjfflag,oflag,tallyflag,zeroflag,tbiasflag,hsflag; int flangevin_allocated; double ascale; double t_start,t_stop,t_period,t_target; @@ -63,6 +65,9 @@ class FixLangevin : public Fix { double **flangevin; double *tforce; double **franprev; + double **lv; //lucas velocity or half-step velocity + double **wildcard; + int nvalues; char *id_temp; From eb447db7c55efc18cd3e6c398fbf31e5f7f56d1b Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 13:51:36 -0700 Subject: [PATCH 052/557] added lammps python example --- examples/python/gjf_python/argon.lmp | 886 +++++++++++++++++++++ examples/python/gjf_python/ff-argon.lmp | 20 + examples/python/gjf_python/gjf.py | 180 +++++ examples/python/gjf_python/lammps_tools.py | 78 ++ 4 files changed, 1164 insertions(+) create mode 100644 examples/python/gjf_python/argon.lmp create mode 100644 examples/python/gjf_python/ff-argon.lmp create mode 100644 examples/python/gjf_python/gjf.py create mode 100644 examples/python/gjf_python/lammps_tools.py diff --git a/examples/python/gjf_python/argon.lmp b/examples/python/gjf_python/argon.lmp new file mode 100644 index 0000000000..00214b4c54 --- /dev/null +++ b/examples/python/gjf_python/argon.lmp @@ -0,0 +1,886 @@ +LAMMPS description + + 864 atoms + 0 bonds + 0 angles + 0 dihedrals + 0 impropers + + 1 atom types + 0 bond types + 0 angle types + 0 dihedral types + 0 improper types + + + 0.0000000 32.146000 xlo xhi + 0.0000000 32.146000 ylo yhi + 0.0000000 32.146000 zlo zhi + + Atoms + + 1 1 1 0.0000000 0.0000000 2.6790000 2.6790000 + 2 2 1 0.0000000 0.0000000 2.6790000 8.0360000 + 3 3 1 0.0000000 0.0000000 2.6790000 13.3940000 + 4 4 1 0.0000000 0.0000000 2.6790000 18.7520000 + 5 5 1 0.0000000 0.0000000 2.6790000 24.1090000 + 6 6 1 0.0000000 0.0000000 2.6790000 29.4670000 + 7 7 1 0.0000000 0.0000000 8.0360000 2.6790000 + 8 8 1 0.0000000 0.0000000 8.0360000 8.0360000 + 9 9 1 0.0000000 0.0000000 8.0360000 13.3940000 + 10 10 1 0.0000000 0.0000000 8.0360000 18.7520000 + 11 11 1 0.0000000 0.0000000 8.0360000 24.1090000 + 12 12 1 0.0000000 0.0000000 8.0360000 29.4670000 + 13 13 1 0.0000000 0.0000000 13.3940000 2.6790000 + 14 14 1 0.0000000 0.0000000 13.3940000 8.0360000 + 15 15 1 0.0000000 0.0000000 13.3940000 13.3940000 + 16 16 1 0.0000000 0.0000000 13.3940000 18.7520000 + 17 17 1 0.0000000 0.0000000 13.3940000 24.1090000 + 18 18 1 0.0000000 0.0000000 13.3940000 29.4670000 + 19 19 1 0.0000000 0.0000000 18.7520000 2.6790000 + 20 20 1 0.0000000 0.0000000 18.7520000 8.0360000 + 21 21 1 0.0000000 0.0000000 18.7520000 13.3940000 + 22 22 1 0.0000000 0.0000000 18.7520000 18.7520000 + 23 23 1 0.0000000 0.0000000 18.7520000 24.1090000 + 24 24 1 0.0000000 0.0000000 18.7520000 29.4670000 + 25 25 1 0.0000000 0.0000000 24.1090000 2.6790000 + 26 26 1 0.0000000 0.0000000 24.1090000 8.0360000 + 27 27 1 0.0000000 0.0000000 24.1090000 13.3940000 + 28 28 1 0.0000000 0.0000000 24.1090000 18.7520000 + 29 29 1 0.0000000 0.0000000 24.1090000 24.1090000 + 30 30 1 0.0000000 0.0000000 24.1090000 29.4670000 + 31 31 1 0.0000000 0.0000000 29.4670000 2.6790000 + 32 32 1 0.0000000 0.0000000 29.4670000 8.0360000 + 33 33 1 0.0000000 0.0000000 29.4670000 13.3940000 + 34 34 1 0.0000000 0.0000000 29.4670000 18.7520000 + 35 35 1 0.0000000 0.0000000 29.4670000 24.1090000 + 36 36 1 0.0000000 0.0000000 29.4670000 29.4670000 + 37 37 1 0.0000000 5.3580000 2.6790000 2.6790000 + 38 38 1 0.0000000 5.3580000 2.6790000 8.0360000 + 39 39 1 0.0000000 5.3580000 2.6790000 13.3940000 + 40 40 1 0.0000000 5.3580000 2.6790000 18.7520000 + 41 41 1 0.0000000 5.3580000 2.6790000 24.1090000 + 42 42 1 0.0000000 5.3580000 2.6790000 29.4670000 + 43 43 1 0.0000000 5.3580000 8.0360000 2.6790000 + 44 44 1 0.0000000 5.3580000 8.0360000 8.0360000 + 45 45 1 0.0000000 5.3580000 8.0360000 13.3940000 + 46 46 1 0.0000000 5.3580000 8.0360000 18.7520000 + 47 47 1 0.0000000 5.3580000 8.0360000 24.1090000 + 48 48 1 0.0000000 5.3580000 8.0360000 29.4670000 + 49 49 1 0.0000000 5.3580000 13.3940000 2.6790000 + 50 50 1 0.0000000 5.3580000 13.3940000 8.0360000 + 51 51 1 0.0000000 5.3580000 13.3940000 13.3940000 + 52 52 1 0.0000000 5.3580000 13.3940000 18.7520000 + 53 53 1 0.0000000 5.3580000 13.3940000 24.1090000 + 54 54 1 0.0000000 5.3580000 13.3940000 29.4670000 + 55 55 1 0.0000000 5.3580000 18.7520000 2.6790000 + 56 56 1 0.0000000 5.3580000 18.7520000 8.0360000 + 57 57 1 0.0000000 5.3580000 18.7520000 13.3940000 + 58 58 1 0.0000000 5.3580000 18.7520000 18.7520000 + 59 59 1 0.0000000 5.3580000 18.7520000 24.1090000 + 60 60 1 0.0000000 5.3580000 18.7520000 29.4670000 + 61 61 1 0.0000000 5.3580000 24.1090000 2.6790000 + 62 62 1 0.0000000 5.3580000 24.1090000 8.0360000 + 63 63 1 0.0000000 5.3580000 24.1090000 13.3940000 + 64 64 1 0.0000000 5.3580000 24.1090000 18.7520000 + 65 65 1 0.0000000 5.3580000 24.1090000 24.1090000 + 66 66 1 0.0000000 5.3580000 24.1090000 29.4670000 + 67 67 1 0.0000000 5.3580000 29.4670000 2.6790000 + 68 68 1 0.0000000 5.3580000 29.4670000 8.0360000 + 69 69 1 0.0000000 5.3580000 29.4670000 13.3940000 + 70 70 1 0.0000000 5.3580000 29.4670000 18.7520000 + 71 71 1 0.0000000 5.3580000 29.4670000 24.1090000 + 72 72 1 0.0000000 5.3580000 29.4670000 29.4670000 + 73 73 1 0.0000000 10.7150000 2.6790000 2.6790000 + 74 74 1 0.0000000 10.7150000 2.6790000 8.0360000 + 75 75 1 0.0000000 10.7150000 2.6790000 13.3940000 + 76 76 1 0.0000000 10.7150000 2.6790000 18.7520000 + 77 77 1 0.0000000 10.7150000 2.6790000 24.1090000 + 78 78 1 0.0000000 10.7150000 2.6790000 29.4670000 + 79 79 1 0.0000000 10.7150000 8.0360000 2.6790000 + 80 80 1 0.0000000 10.7150000 8.0360000 8.0360000 + 81 81 1 0.0000000 10.7150000 8.0360000 13.3940000 + 82 82 1 0.0000000 10.7150000 8.0360000 18.7520000 + 83 83 1 0.0000000 10.7150000 8.0360000 24.1090000 + 84 84 1 0.0000000 10.7150000 8.0360000 29.4670000 + 85 85 1 0.0000000 10.7150000 13.3940000 2.6790000 + 86 86 1 0.0000000 10.7150000 13.3940000 8.0360000 + 87 87 1 0.0000000 10.7150000 13.3940000 13.3940000 + 88 88 1 0.0000000 10.7150000 13.3940000 18.7520000 + 89 89 1 0.0000000 10.7150000 13.3940000 24.1090000 + 90 90 1 0.0000000 10.7150000 13.3940000 29.4670000 + 91 91 1 0.0000000 10.7150000 18.7520000 2.6790000 + 92 92 1 0.0000000 10.7150000 18.7520000 8.0360000 + 93 93 1 0.0000000 10.7150000 18.7520000 13.3940000 + 94 94 1 0.0000000 10.7150000 18.7520000 18.7520000 + 95 95 1 0.0000000 10.7150000 18.7520000 24.1090000 + 96 96 1 0.0000000 10.7150000 18.7520000 29.4670000 + 97 97 1 0.0000000 10.7150000 24.1090000 2.6790000 + 98 98 1 0.0000000 10.7150000 24.1090000 8.0360000 + 99 99 1 0.0000000 10.7150000 24.1090000 13.3940000 + 100 100 1 0.0000000 10.7150000 24.1090000 18.7520000 + 101 101 1 0.0000000 10.7150000 24.1090000 24.1090000 + 102 102 1 0.0000000 10.7150000 24.1090000 29.4670000 + 103 103 1 0.0000000 10.7150000 29.4670000 2.6790000 + 104 104 1 0.0000000 10.7150000 29.4670000 8.0360000 + 105 105 1 0.0000000 10.7150000 29.4670000 13.3940000 + 106 106 1 0.0000000 10.7150000 29.4670000 18.7520000 + 107 107 1 0.0000000 10.7150000 29.4670000 24.1090000 + 108 108 1 0.0000000 10.7150000 29.4670000 29.4670000 + 109 109 1 0.0000000 16.0730000 2.6790000 2.6790000 + 110 110 1 0.0000000 16.0730000 2.6790000 8.0360000 + 111 111 1 0.0000000 16.0730000 2.6790000 13.3940000 + 112 112 1 0.0000000 16.0730000 2.6790000 18.7520000 + 113 113 1 0.0000000 16.0730000 2.6790000 24.1090000 + 114 114 1 0.0000000 16.0730000 2.6790000 29.4670000 + 115 115 1 0.0000000 16.0730000 8.0360000 2.6790000 + 116 116 1 0.0000000 16.0730000 8.0360000 8.0360000 + 117 117 1 0.0000000 16.0730000 8.0360000 13.3940000 + 118 118 1 0.0000000 16.0730000 8.0360000 18.7520000 + 119 119 1 0.0000000 16.0730000 8.0360000 24.1090000 + 120 120 1 0.0000000 16.0730000 8.0360000 29.4670000 + 121 121 1 0.0000000 16.0730000 13.3940000 2.6790000 + 122 122 1 0.0000000 16.0730000 13.3940000 8.0360000 + 123 123 1 0.0000000 16.0730000 13.3940000 13.3940000 + 124 124 1 0.0000000 16.0730000 13.3940000 18.7520000 + 125 125 1 0.0000000 16.0730000 13.3940000 24.1090000 + 126 126 1 0.0000000 16.0730000 13.3940000 29.4670000 + 127 127 1 0.0000000 16.0730000 18.7520000 2.6790000 + 128 128 1 0.0000000 16.0730000 18.7520000 8.0360000 + 129 129 1 0.0000000 16.0730000 18.7520000 13.3940000 + 130 130 1 0.0000000 16.0730000 18.7520000 18.7520000 + 131 131 1 0.0000000 16.0730000 18.7520000 24.1090000 + 132 132 1 0.0000000 16.0730000 18.7520000 29.4670000 + 133 133 1 0.0000000 16.0730000 24.1090000 2.6790000 + 134 134 1 0.0000000 16.0730000 24.1090000 8.0360000 + 135 135 1 0.0000000 16.0730000 24.1090000 13.3940000 + 136 136 1 0.0000000 16.0730000 24.1090000 18.7520000 + 137 137 1 0.0000000 16.0730000 24.1090000 24.1090000 + 138 138 1 0.0000000 16.0730000 24.1090000 29.4670000 + 139 139 1 0.0000000 16.0730000 29.4670000 2.6790000 + 140 140 1 0.0000000 16.0730000 29.4670000 8.0360000 + 141 141 1 0.0000000 16.0730000 29.4670000 13.3940000 + 142 142 1 0.0000000 16.0730000 29.4670000 18.7520000 + 143 143 1 0.0000000 16.0730000 29.4670000 24.1090000 + 144 144 1 0.0000000 16.0730000 29.4670000 29.4670000 + 145 145 1 0.0000000 21.4310000 2.6790000 2.6790000 + 146 146 1 0.0000000 21.4310000 2.6790000 8.0360000 + 147 147 1 0.0000000 21.4310000 2.6790000 13.3940000 + 148 148 1 0.0000000 21.4310000 2.6790000 18.7520000 + 149 149 1 0.0000000 21.4310000 2.6790000 24.1090000 + 150 150 1 0.0000000 21.4310000 2.6790000 29.4670000 + 151 151 1 0.0000000 21.4310000 8.0360000 2.6790000 + 152 152 1 0.0000000 21.4310000 8.0360000 8.0360000 + 153 153 1 0.0000000 21.4310000 8.0360000 13.3940000 + 154 154 1 0.0000000 21.4310000 8.0360000 18.7520000 + 155 155 1 0.0000000 21.4310000 8.0360000 24.1090000 + 156 156 1 0.0000000 21.4310000 8.0360000 29.4670000 + 157 157 1 0.0000000 21.4310000 13.3940000 2.6790000 + 158 158 1 0.0000000 21.4310000 13.3940000 8.0360000 + 159 159 1 0.0000000 21.4310000 13.3940000 13.3940000 + 160 160 1 0.0000000 21.4310000 13.3940000 18.7520000 + 161 161 1 0.0000000 21.4310000 13.3940000 24.1090000 + 162 162 1 0.0000000 21.4310000 13.3940000 29.4670000 + 163 163 1 0.0000000 21.4310000 18.7520000 2.6790000 + 164 164 1 0.0000000 21.4310000 18.7520000 8.0360000 + 165 165 1 0.0000000 21.4310000 18.7520000 13.3940000 + 166 166 1 0.0000000 21.4310000 18.7520000 18.7520000 + 167 167 1 0.0000000 21.4310000 18.7520000 24.1090000 + 168 168 1 0.0000000 21.4310000 18.7520000 29.4670000 + 169 169 1 0.0000000 21.4310000 24.1090000 2.6790000 + 170 170 1 0.0000000 21.4310000 24.1090000 8.0360000 + 171 171 1 0.0000000 21.4310000 24.1090000 13.3940000 + 172 172 1 0.0000000 21.4310000 24.1090000 18.7520000 + 173 173 1 0.0000000 21.4310000 24.1090000 24.1090000 + 174 174 1 0.0000000 21.4310000 24.1090000 29.4670000 + 175 175 1 0.0000000 21.4310000 29.4670000 2.6790000 + 176 176 1 0.0000000 21.4310000 29.4670000 8.0360000 + 177 177 1 0.0000000 21.4310000 29.4670000 13.3940000 + 178 178 1 0.0000000 21.4310000 29.4670000 18.7520000 + 179 179 1 0.0000000 21.4310000 29.4670000 24.1090000 + 180 180 1 0.0000000 21.4310000 29.4670000 29.4670000 + 181 181 1 0.0000000 26.7880000 2.6790000 2.6790000 + 182 182 1 0.0000000 26.7880000 2.6790000 8.0360000 + 183 183 1 0.0000000 26.7880000 2.6790000 13.3940000 + 184 184 1 0.0000000 26.7880000 2.6790000 18.7520000 + 185 185 1 0.0000000 26.7880000 2.6790000 24.1090000 + 186 186 1 0.0000000 26.7880000 2.6790000 29.4670000 + 187 187 1 0.0000000 26.7880000 8.0360000 2.6790000 + 188 188 1 0.0000000 26.7880000 8.0360000 8.0360000 + 189 189 1 0.0000000 26.7880000 8.0360000 13.3940000 + 190 190 1 0.0000000 26.7880000 8.0360000 18.7520000 + 191 191 1 0.0000000 26.7880000 8.0360000 24.1090000 + 192 192 1 0.0000000 26.7880000 8.0360000 29.4670000 + 193 193 1 0.0000000 26.7880000 13.3940000 2.6790000 + 194 194 1 0.0000000 26.7880000 13.3940000 8.0360000 + 195 195 1 0.0000000 26.7880000 13.3940000 13.3940000 + 196 196 1 0.0000000 26.7880000 13.3940000 18.7520000 + 197 197 1 0.0000000 26.7880000 13.3940000 24.1090000 + 198 198 1 0.0000000 26.7880000 13.3940000 29.4670000 + 199 199 1 0.0000000 26.7880000 18.7520000 2.6790000 + 200 200 1 0.0000000 26.7880000 18.7520000 8.0360000 + 201 201 1 0.0000000 26.7880000 18.7520000 13.3940000 + 202 202 1 0.0000000 26.7880000 18.7520000 18.7520000 + 203 203 1 0.0000000 26.7880000 18.7520000 24.1090000 + 204 204 1 0.0000000 26.7880000 18.7520000 29.4670000 + 205 205 1 0.0000000 26.7880000 24.1090000 2.6790000 + 206 206 1 0.0000000 26.7880000 24.1090000 8.0360000 + 207 207 1 0.0000000 26.7880000 24.1090000 13.3940000 + 208 208 1 0.0000000 26.7880000 24.1090000 18.7520000 + 209 209 1 0.0000000 26.7880000 24.1090000 24.1090000 + 210 210 1 0.0000000 26.7880000 24.1090000 29.4670000 + 211 211 1 0.0000000 26.7880000 29.4670000 2.6790000 + 212 212 1 0.0000000 26.7880000 29.4670000 8.0360000 + 213 213 1 0.0000000 26.7880000 29.4670000 13.3940000 + 214 214 1 0.0000000 26.7880000 29.4670000 18.7520000 + 215 215 1 0.0000000 26.7880000 29.4670000 24.1090000 + 216 216 1 0.0000000 26.7880000 29.4670000 29.4670000 + 217 217 1 0.0000000 2.6790000 5.3580000 2.6790000 + 218 218 1 0.0000000 2.6790000 5.3580000 8.0360000 + 219 219 1 0.0000000 2.6790000 5.3580000 13.3940000 + 220 220 1 0.0000000 2.6790000 5.3580000 18.7520000 + 221 221 1 0.0000000 2.6790000 5.3580000 24.1090000 + 222 222 1 0.0000000 2.6790000 5.3580000 29.4670000 + 223 223 1 0.0000000 2.6790000 10.7150000 2.6790000 + 224 224 1 0.0000000 2.6790000 10.7150000 8.0360000 + 225 225 1 0.0000000 2.6790000 10.7150000 13.3940000 + 226 226 1 0.0000000 2.6790000 10.7150000 18.7520000 + 227 227 1 0.0000000 2.6790000 10.7150000 24.1090000 + 228 228 1 0.0000000 2.6790000 10.7150000 29.4670000 + 229 229 1 0.0000000 2.6790000 16.0730000 2.6790000 + 230 230 1 0.0000000 2.6790000 16.0730000 8.0360000 + 231 231 1 0.0000000 2.6790000 16.0730000 13.3940000 + 232 232 1 0.0000000 2.6790000 16.0730000 18.7520000 + 233 233 1 0.0000000 2.6790000 16.0730000 24.1090000 + 234 234 1 0.0000000 2.6790000 16.0730000 29.4670000 + 235 235 1 0.0000000 2.6790000 21.4310000 2.6790000 + 236 236 1 0.0000000 2.6790000 21.4310000 8.0360000 + 237 237 1 0.0000000 2.6790000 21.4310000 13.3940000 + 238 238 1 0.0000000 2.6790000 21.4310000 18.7520000 + 239 239 1 0.0000000 2.6790000 21.4310000 24.1090000 + 240 240 1 0.0000000 2.6790000 21.4310000 29.4670000 + 241 241 1 0.0000000 2.6790000 26.7880000 2.6790000 + 242 242 1 0.0000000 2.6790000 26.7880000 8.0360000 + 243 243 1 0.0000000 2.6790000 26.7880000 13.3940000 + 244 244 1 0.0000000 2.6790000 26.7880000 18.7520000 + 245 245 1 0.0000000 2.6790000 26.7880000 24.1090000 + 246 246 1 0.0000000 2.6790000 26.7880000 29.4670000 + 247 247 1 0.0000000 2.6790000 32.1460000 2.6790000 + 248 248 1 0.0000000 2.6790000 32.1460000 8.0360000 + 249 249 1 0.0000000 2.6790000 32.1460000 13.3940000 + 250 250 1 0.0000000 2.6790000 32.1460000 18.7520000 + 251 251 1 0.0000000 2.6790000 32.1460000 24.1090000 + 252 252 1 0.0000000 2.6790000 32.1460000 29.4670000 + 253 253 1 0.0000000 8.0360000 5.3580000 2.6790000 + 254 254 1 0.0000000 8.0360000 5.3580000 8.0360000 + 255 255 1 0.0000000 8.0360000 5.3580000 13.3940000 + 256 256 1 0.0000000 8.0360000 5.3580000 18.7520000 + 257 257 1 0.0000000 8.0360000 5.3580000 24.1090000 + 258 258 1 0.0000000 8.0360000 5.3580000 29.4670000 + 259 259 1 0.0000000 8.0360000 10.7150000 2.6790000 + 260 260 1 0.0000000 8.0360000 10.7150000 8.0360000 + 261 261 1 0.0000000 8.0360000 10.7150000 13.3940000 + 262 262 1 0.0000000 8.0360000 10.7150000 18.7520000 + 263 263 1 0.0000000 8.0360000 10.7150000 24.1090000 + 264 264 1 0.0000000 8.0360000 10.7150000 29.4670000 + 265 265 1 0.0000000 8.0360000 16.0730000 2.6790000 + 266 266 1 0.0000000 8.0360000 16.0730000 8.0360000 + 267 267 1 0.0000000 8.0360000 16.0730000 13.3940000 + 268 268 1 0.0000000 8.0360000 16.0730000 18.7520000 + 269 269 1 0.0000000 8.0360000 16.0730000 24.1090000 + 270 270 1 0.0000000 8.0360000 16.0730000 29.4670000 + 271 271 1 0.0000000 8.0360000 21.4310000 2.6790000 + 272 272 1 0.0000000 8.0360000 21.4310000 8.0360000 + 273 273 1 0.0000000 8.0360000 21.4310000 13.3940000 + 274 274 1 0.0000000 8.0360000 21.4310000 18.7520000 + 275 275 1 0.0000000 8.0360000 21.4310000 24.1090000 + 276 276 1 0.0000000 8.0360000 21.4310000 29.4670000 + 277 277 1 0.0000000 8.0360000 26.7880000 2.6790000 + 278 278 1 0.0000000 8.0360000 26.7880000 8.0360000 + 279 279 1 0.0000000 8.0360000 26.7880000 13.3940000 + 280 280 1 0.0000000 8.0360000 26.7880000 18.7520000 + 281 281 1 0.0000000 8.0360000 26.7880000 24.1090000 + 282 282 1 0.0000000 8.0360000 26.7880000 29.4670000 + 283 283 1 0.0000000 8.0360000 32.1460000 2.6790000 + 284 284 1 0.0000000 8.0360000 32.1460000 8.0360000 + 285 285 1 0.0000000 8.0360000 32.1460000 13.3940000 + 286 286 1 0.0000000 8.0360000 32.1460000 18.7520000 + 287 287 1 0.0000000 8.0360000 32.1460000 24.1090000 + 288 288 1 0.0000000 8.0360000 32.1460000 29.4670000 + 289 289 1 0.0000000 13.3940000 5.3580000 2.6790000 + 290 290 1 0.0000000 13.3940000 5.3580000 8.0360000 + 291 291 1 0.0000000 13.3940000 5.3580000 13.3940000 + 292 292 1 0.0000000 13.3940000 5.3580000 18.7520000 + 293 293 1 0.0000000 13.3940000 5.3580000 24.1090000 + 294 294 1 0.0000000 13.3940000 5.3580000 29.4670000 + 295 295 1 0.0000000 13.3940000 10.7150000 2.6790000 + 296 296 1 0.0000000 13.3940000 10.7150000 8.0360000 + 297 297 1 0.0000000 13.3940000 10.7150000 13.3940000 + 298 298 1 0.0000000 13.3940000 10.7150000 18.7520000 + 299 299 1 0.0000000 13.3940000 10.7150000 24.1090000 + 300 300 1 0.0000000 13.3940000 10.7150000 29.4670000 + 301 301 1 0.0000000 13.3940000 16.0730000 2.6790000 + 302 302 1 0.0000000 13.3940000 16.0730000 8.0360000 + 303 303 1 0.0000000 13.3940000 16.0730000 13.3940000 + 304 304 1 0.0000000 13.3940000 16.0730000 18.7520000 + 305 305 1 0.0000000 13.3940000 16.0730000 24.1090000 + 306 306 1 0.0000000 13.3940000 16.0730000 29.4670000 + 307 307 1 0.0000000 13.3940000 21.4310000 2.6790000 + 308 308 1 0.0000000 13.3940000 21.4310000 8.0360000 + 309 309 1 0.0000000 13.3940000 21.4310000 13.3940000 + 310 310 1 0.0000000 13.3940000 21.4310000 18.7520000 + 311 311 1 0.0000000 13.3940000 21.4310000 24.1090000 + 312 312 1 0.0000000 13.3940000 21.4310000 29.4670000 + 313 313 1 0.0000000 13.3940000 26.7880000 2.6790000 + 314 314 1 0.0000000 13.3940000 26.7880000 8.0360000 + 315 315 1 0.0000000 13.3940000 26.7880000 13.3940000 + 316 316 1 0.0000000 13.3940000 26.7880000 18.7520000 + 317 317 1 0.0000000 13.3940000 26.7880000 24.1090000 + 318 318 1 0.0000000 13.3940000 26.7880000 29.4670000 + 319 319 1 0.0000000 13.3940000 32.1460000 2.6790000 + 320 320 1 0.0000000 13.3940000 32.1460000 8.0360000 + 321 321 1 0.0000000 13.3940000 32.1460000 13.3940000 + 322 322 1 0.0000000 13.3940000 32.1460000 18.7520000 + 323 323 1 0.0000000 13.3940000 32.1460000 24.1090000 + 324 324 1 0.0000000 13.3940000 32.1460000 29.4670000 + 325 325 1 0.0000000 18.7520000 5.3580000 2.6790000 + 326 326 1 0.0000000 18.7520000 5.3580000 8.0360000 + 327 327 1 0.0000000 18.7520000 5.3580000 13.3940000 + 328 328 1 0.0000000 18.7520000 5.3580000 18.7520000 + 329 329 1 0.0000000 18.7520000 5.3580000 24.1090000 + 330 330 1 0.0000000 18.7520000 5.3580000 29.4670000 + 331 331 1 0.0000000 18.7520000 10.7150000 2.6790000 + 332 332 1 0.0000000 18.7520000 10.7150000 8.0360000 + 333 333 1 0.0000000 18.7520000 10.7150000 13.3940000 + 334 334 1 0.0000000 18.7520000 10.7150000 18.7520000 + 335 335 1 0.0000000 18.7520000 10.7150000 24.1090000 + 336 336 1 0.0000000 18.7520000 10.7150000 29.4670000 + 337 337 1 0.0000000 18.7520000 16.0730000 2.6790000 + 338 338 1 0.0000000 18.7520000 16.0730000 8.0360000 + 339 339 1 0.0000000 18.7520000 16.0730000 13.3940000 + 340 340 1 0.0000000 18.7520000 16.0730000 18.7520000 + 341 341 1 0.0000000 18.7520000 16.0730000 24.1090000 + 342 342 1 0.0000000 18.7520000 16.0730000 29.4670000 + 343 343 1 0.0000000 18.7520000 21.4310000 2.6790000 + 344 344 1 0.0000000 18.7520000 21.4310000 8.0360000 + 345 345 1 0.0000000 18.7520000 21.4310000 13.3940000 + 346 346 1 0.0000000 18.7520000 21.4310000 18.7520000 + 347 347 1 0.0000000 18.7520000 21.4310000 24.1090000 + 348 348 1 0.0000000 18.7520000 21.4310000 29.4670000 + 349 349 1 0.0000000 18.7520000 26.7880000 2.6790000 + 350 350 1 0.0000000 18.7520000 26.7880000 8.0360000 + 351 351 1 0.0000000 18.7520000 26.7880000 13.3940000 + 352 352 1 0.0000000 18.7520000 26.7880000 18.7520000 + 353 353 1 0.0000000 18.7520000 26.7880000 24.1090000 + 354 354 1 0.0000000 18.7520000 26.7880000 29.4670000 + 355 355 1 0.0000000 18.7520000 32.1460000 2.6790000 + 356 356 1 0.0000000 18.7520000 32.1460000 8.0360000 + 357 357 1 0.0000000 18.7520000 32.1460000 13.3940000 + 358 358 1 0.0000000 18.7520000 32.1460000 18.7520000 + 359 359 1 0.0000000 18.7520000 32.1460000 24.1090000 + 360 360 1 0.0000000 18.7520000 32.1460000 29.4670000 + 361 361 1 0.0000000 24.1090000 5.3580000 2.6790000 + 362 362 1 0.0000000 24.1090000 5.3580000 8.0360000 + 363 363 1 0.0000000 24.1090000 5.3580000 13.3940000 + 364 364 1 0.0000000 24.1090000 5.3580000 18.7520000 + 365 365 1 0.0000000 24.1090000 5.3580000 24.1090000 + 366 366 1 0.0000000 24.1090000 5.3580000 29.4670000 + 367 367 1 0.0000000 24.1090000 10.7150000 2.6790000 + 368 368 1 0.0000000 24.1090000 10.7150000 8.0360000 + 369 369 1 0.0000000 24.1090000 10.7150000 13.3940000 + 370 370 1 0.0000000 24.1090000 10.7150000 18.7520000 + 371 371 1 0.0000000 24.1090000 10.7150000 24.1090000 + 372 372 1 0.0000000 24.1090000 10.7150000 29.4670000 + 373 373 1 0.0000000 24.1090000 16.0730000 2.6790000 + 374 374 1 0.0000000 24.1090000 16.0730000 8.0360000 + 375 375 1 0.0000000 24.1090000 16.0730000 13.3940000 + 376 376 1 0.0000000 24.1090000 16.0730000 18.7520000 + 377 377 1 0.0000000 24.1090000 16.0730000 24.1090000 + 378 378 1 0.0000000 24.1090000 16.0730000 29.4670000 + 379 379 1 0.0000000 24.1090000 21.4310000 2.6790000 + 380 380 1 0.0000000 24.1090000 21.4310000 8.0360000 + 381 381 1 0.0000000 24.1090000 21.4310000 13.3940000 + 382 382 1 0.0000000 24.1090000 21.4310000 18.7520000 + 383 383 1 0.0000000 24.1090000 21.4310000 24.1090000 + 384 384 1 0.0000000 24.1090000 21.4310000 29.4670000 + 385 385 1 0.0000000 24.1090000 26.7880000 2.6790000 + 386 386 1 0.0000000 24.1090000 26.7880000 8.0360000 + 387 387 1 0.0000000 24.1090000 26.7880000 13.3940000 + 388 388 1 0.0000000 24.1090000 26.7880000 18.7520000 + 389 389 1 0.0000000 24.1090000 26.7880000 24.1090000 + 390 390 1 0.0000000 24.1090000 26.7880000 29.4670000 + 391 391 1 0.0000000 24.1090000 32.1460000 2.6790000 + 392 392 1 0.0000000 24.1090000 32.1460000 8.0360000 + 393 393 1 0.0000000 24.1090000 32.1460000 13.3940000 + 394 394 1 0.0000000 24.1090000 32.1460000 18.7520000 + 395 395 1 0.0000000 24.1090000 32.1460000 24.1090000 + 396 396 1 0.0000000 24.1090000 32.1460000 29.4670000 + 397 397 1 0.0000000 29.4670000 5.3580000 2.6790000 + 398 398 1 0.0000000 29.4670000 5.3580000 8.0360000 + 399 399 1 0.0000000 29.4670000 5.3580000 13.3940000 + 400 400 1 0.0000000 29.4670000 5.3580000 18.7520000 + 401 401 1 0.0000000 29.4670000 5.3580000 24.1090000 + 402 402 1 0.0000000 29.4670000 5.3580000 29.4670000 + 403 403 1 0.0000000 29.4670000 10.7150000 2.6790000 + 404 404 1 0.0000000 29.4670000 10.7150000 8.0360000 + 405 405 1 0.0000000 29.4670000 10.7150000 13.3940000 + 406 406 1 0.0000000 29.4670000 10.7150000 18.7520000 + 407 407 1 0.0000000 29.4670000 10.7150000 24.1090000 + 408 408 1 0.0000000 29.4670000 10.7150000 29.4670000 + 409 409 1 0.0000000 29.4670000 16.0730000 2.6790000 + 410 410 1 0.0000000 29.4670000 16.0730000 8.0360000 + 411 411 1 0.0000000 29.4670000 16.0730000 13.3940000 + 412 412 1 0.0000000 29.4670000 16.0730000 18.7520000 + 413 413 1 0.0000000 29.4670000 16.0730000 24.1090000 + 414 414 1 0.0000000 29.4670000 16.0730000 29.4670000 + 415 415 1 0.0000000 29.4670000 21.4310000 2.6790000 + 416 416 1 0.0000000 29.4670000 21.4310000 8.0360000 + 417 417 1 0.0000000 29.4670000 21.4310000 13.3940000 + 418 418 1 0.0000000 29.4670000 21.4310000 18.7520000 + 419 419 1 0.0000000 29.4670000 21.4310000 24.1090000 + 420 420 1 0.0000000 29.4670000 21.4310000 29.4670000 + 421 421 1 0.0000000 29.4670000 26.7880000 2.6790000 + 422 422 1 0.0000000 29.4670000 26.7880000 8.0360000 + 423 423 1 0.0000000 29.4670000 26.7880000 13.3940000 + 424 424 1 0.0000000 29.4670000 26.7880000 18.7520000 + 425 425 1 0.0000000 29.4670000 26.7880000 24.1090000 + 426 426 1 0.0000000 29.4670000 26.7880000 29.4670000 + 427 427 1 0.0000000 29.4670000 32.1460000 2.6790000 + 428 428 1 0.0000000 29.4670000 32.1460000 8.0360000 + 429 429 1 0.0000000 29.4670000 32.1460000 13.3940000 + 430 430 1 0.0000000 29.4670000 32.1460000 18.7520000 + 431 431 1 0.0000000 29.4670000 32.1460000 24.1090000 + 432 432 1 0.0000000 29.4670000 32.1460000 29.4670000 + 433 433 1 0.0000000 2.6790000 2.6790000 5.3580000 + 434 434 1 0.0000000 2.6790000 2.6790000 10.7150000 + 435 435 1 0.0000000 2.6790000 2.6790000 16.0730000 + 436 436 1 0.0000000 2.6790000 2.6790000 21.4310000 + 437 437 1 0.0000000 2.6790000 2.6790000 26.7880000 + 438 438 1 0.0000000 2.6790000 2.6790000 32.1460000 + 439 439 1 0.0000000 2.6790000 8.0360000 5.3580000 + 440 440 1 0.0000000 2.6790000 8.0360000 10.7150000 + 441 441 1 0.0000000 2.6790000 8.0360000 16.0730000 + 442 442 1 0.0000000 2.6790000 8.0360000 21.4310000 + 443 443 1 0.0000000 2.6790000 8.0360000 26.7880000 + 444 444 1 0.0000000 2.6790000 8.0360000 32.1460000 + 445 445 1 0.0000000 2.6790000 13.3940000 5.3580000 + 446 446 1 0.0000000 2.6790000 13.3940000 10.7150000 + 447 447 1 0.0000000 2.6790000 13.3940000 16.0730000 + 448 448 1 0.0000000 2.6790000 13.3940000 21.4310000 + 449 449 1 0.0000000 2.6790000 13.3940000 26.7880000 + 450 450 1 0.0000000 2.6790000 13.3940000 32.1460000 + 451 451 1 0.0000000 2.6790000 18.7520000 5.3580000 + 452 452 1 0.0000000 2.6790000 18.7520000 10.7150000 + 453 453 1 0.0000000 2.6790000 18.7520000 16.0730000 + 454 454 1 0.0000000 2.6790000 18.7520000 21.4310000 + 455 455 1 0.0000000 2.6790000 18.7520000 26.7880000 + 456 456 1 0.0000000 2.6790000 18.7520000 32.1460000 + 457 457 1 0.0000000 2.6790000 24.1090000 5.3580000 + 458 458 1 0.0000000 2.6790000 24.1090000 10.7150000 + 459 459 1 0.0000000 2.6790000 24.1090000 16.0730000 + 460 460 1 0.0000000 2.6790000 24.1090000 21.4310000 + 461 461 1 0.0000000 2.6790000 24.1090000 26.7880000 + 462 462 1 0.0000000 2.6790000 24.1090000 32.1460000 + 463 463 1 0.0000000 2.6790000 29.4670000 5.3580000 + 464 464 1 0.0000000 2.6790000 29.4670000 10.7150000 + 465 465 1 0.0000000 2.6790000 29.4670000 16.0730000 + 466 466 1 0.0000000 2.6790000 29.4670000 21.4310000 + 467 467 1 0.0000000 2.6790000 29.4670000 26.7880000 + 468 468 1 0.0000000 2.6790000 29.4670000 32.1460000 + 469 469 1 0.0000000 8.0360000 2.6790000 5.3580000 + 470 470 1 0.0000000 8.0360000 2.6790000 10.7150000 + 471 471 1 0.0000000 8.0360000 2.6790000 16.0730000 + 472 472 1 0.0000000 8.0360000 2.6790000 21.4310000 + 473 473 1 0.0000000 8.0360000 2.6790000 26.7880000 + 474 474 1 0.0000000 8.0360000 2.6790000 32.1460000 + 475 475 1 0.0000000 8.0360000 8.0360000 5.3580000 + 476 476 1 0.0000000 8.0360000 8.0360000 10.7150000 + 477 477 1 0.0000000 8.0360000 8.0360000 16.0730000 + 478 478 1 0.0000000 8.0360000 8.0360000 21.4310000 + 479 479 1 0.0000000 8.0360000 8.0360000 26.7880000 + 480 480 1 0.0000000 8.0360000 8.0360000 32.1460000 + 481 481 1 0.0000000 8.0360000 13.3940000 5.3580000 + 482 482 1 0.0000000 8.0360000 13.3940000 10.7150000 + 483 483 1 0.0000000 8.0360000 13.3940000 16.0730000 + 484 484 1 0.0000000 8.0360000 13.3940000 21.4310000 + 485 485 1 0.0000000 8.0360000 13.3940000 26.7880000 + 486 486 1 0.0000000 8.0360000 13.3940000 32.1460000 + 487 487 1 0.0000000 8.0360000 18.7520000 5.3580000 + 488 488 1 0.0000000 8.0360000 18.7520000 10.7150000 + 489 489 1 0.0000000 8.0360000 18.7520000 16.0730000 + 490 490 1 0.0000000 8.0360000 18.7520000 21.4310000 + 491 491 1 0.0000000 8.0360000 18.7520000 26.7880000 + 492 492 1 0.0000000 8.0360000 18.7520000 32.1460000 + 493 493 1 0.0000000 8.0360000 24.1090000 5.3580000 + 494 494 1 0.0000000 8.0360000 24.1090000 10.7150000 + 495 495 1 0.0000000 8.0360000 24.1090000 16.0730000 + 496 496 1 0.0000000 8.0360000 24.1090000 21.4310000 + 497 497 1 0.0000000 8.0360000 24.1090000 26.7880000 + 498 498 1 0.0000000 8.0360000 24.1090000 32.1460000 + 499 499 1 0.0000000 8.0360000 29.4670000 5.3580000 + 500 500 1 0.0000000 8.0360000 29.4670000 10.7150000 + 501 501 1 0.0000000 8.0360000 29.4670000 16.0730000 + 502 502 1 0.0000000 8.0360000 29.4670000 21.4310000 + 503 503 1 0.0000000 8.0360000 29.4670000 26.7880000 + 504 504 1 0.0000000 8.0360000 29.4670000 32.1460000 + 505 505 1 0.0000000 13.3940000 2.6790000 5.3580000 + 506 506 1 0.0000000 13.3940000 2.6790000 10.7150000 + 507 507 1 0.0000000 13.3940000 2.6790000 16.0730000 + 508 508 1 0.0000000 13.3940000 2.6790000 21.4310000 + 509 509 1 0.0000000 13.3940000 2.6790000 26.7880000 + 510 510 1 0.0000000 13.3940000 2.6790000 32.1460000 + 511 511 1 0.0000000 13.3940000 8.0360000 5.3580000 + 512 512 1 0.0000000 13.3940000 8.0360000 10.7150000 + 513 513 1 0.0000000 13.3940000 8.0360000 16.0730000 + 514 514 1 0.0000000 13.3940000 8.0360000 21.4310000 + 515 515 1 0.0000000 13.3940000 8.0360000 26.7880000 + 516 516 1 0.0000000 13.3940000 8.0360000 32.1460000 + 517 517 1 0.0000000 13.3940000 13.3940000 5.3580000 + 518 518 1 0.0000000 13.3940000 13.3940000 10.7150000 + 519 519 1 0.0000000 13.3940000 13.3940000 16.0730000 + 520 520 1 0.0000000 13.3940000 13.3940000 21.4310000 + 521 521 1 0.0000000 13.3940000 13.3940000 26.7880000 + 522 522 1 0.0000000 13.3940000 13.3940000 32.1460000 + 523 523 1 0.0000000 13.3940000 18.7520000 5.3580000 + 524 524 1 0.0000000 13.3940000 18.7520000 10.7150000 + 525 525 1 0.0000000 13.3940000 18.7520000 16.0730000 + 526 526 1 0.0000000 13.3940000 18.7520000 21.4310000 + 527 527 1 0.0000000 13.3940000 18.7520000 26.7880000 + 528 528 1 0.0000000 13.3940000 18.7520000 32.1460000 + 529 529 1 0.0000000 13.3940000 24.1090000 5.3580000 + 530 530 1 0.0000000 13.3940000 24.1090000 10.7150000 + 531 531 1 0.0000000 13.3940000 24.1090000 16.0730000 + 532 532 1 0.0000000 13.3940000 24.1090000 21.4310000 + 533 533 1 0.0000000 13.3940000 24.1090000 26.7880000 + 534 534 1 0.0000000 13.3940000 24.1090000 32.1460000 + 535 535 1 0.0000000 13.3940000 29.4670000 5.3580000 + 536 536 1 0.0000000 13.3940000 29.4670000 10.7150000 + 537 537 1 0.0000000 13.3940000 29.4670000 16.0730000 + 538 538 1 0.0000000 13.3940000 29.4670000 21.4310000 + 539 539 1 0.0000000 13.3940000 29.4670000 26.7880000 + 540 540 1 0.0000000 13.3940000 29.4670000 32.1460000 + 541 541 1 0.0000000 18.7520000 2.6790000 5.3580000 + 542 542 1 0.0000000 18.7520000 2.6790000 10.7150000 + 543 543 1 0.0000000 18.7520000 2.6790000 16.0730000 + 544 544 1 0.0000000 18.7520000 2.6790000 21.4310000 + 545 545 1 0.0000000 18.7520000 2.6790000 26.7880000 + 546 546 1 0.0000000 18.7520000 2.6790000 32.1460000 + 547 547 1 0.0000000 18.7520000 8.0360000 5.3580000 + 548 548 1 0.0000000 18.7520000 8.0360000 10.7150000 + 549 549 1 0.0000000 18.7520000 8.0360000 16.0730000 + 550 550 1 0.0000000 18.7520000 8.0360000 21.4310000 + 551 551 1 0.0000000 18.7520000 8.0360000 26.7880000 + 552 552 1 0.0000000 18.7520000 8.0360000 32.1460000 + 553 553 1 0.0000000 18.7520000 13.3940000 5.3580000 + 554 554 1 0.0000000 18.7520000 13.3940000 10.7150000 + 555 555 1 0.0000000 18.7520000 13.3940000 16.0730000 + 556 556 1 0.0000000 18.7520000 13.3940000 21.4310000 + 557 557 1 0.0000000 18.7520000 13.3940000 26.7880000 + 558 558 1 0.0000000 18.7520000 13.3940000 32.1460000 + 559 559 1 0.0000000 18.7520000 18.7520000 5.3580000 + 560 560 1 0.0000000 18.7520000 18.7520000 10.7150000 + 561 561 1 0.0000000 18.7520000 18.7520000 16.0730000 + 562 562 1 0.0000000 18.7520000 18.7520000 21.4310000 + 563 563 1 0.0000000 18.7520000 18.7520000 26.7880000 + 564 564 1 0.0000000 18.7520000 18.7520000 32.1460000 + 565 565 1 0.0000000 18.7520000 24.1090000 5.3580000 + 566 566 1 0.0000000 18.7520000 24.1090000 10.7150000 + 567 567 1 0.0000000 18.7520000 24.1090000 16.0730000 + 568 568 1 0.0000000 18.7520000 24.1090000 21.4310000 + 569 569 1 0.0000000 18.7520000 24.1090000 26.7880000 + 570 570 1 0.0000000 18.7520000 24.1090000 32.1460000 + 571 571 1 0.0000000 18.7520000 29.4670000 5.3580000 + 572 572 1 0.0000000 18.7520000 29.4670000 10.7150000 + 573 573 1 0.0000000 18.7520000 29.4670000 16.0730000 + 574 574 1 0.0000000 18.7520000 29.4670000 21.4310000 + 575 575 1 0.0000000 18.7520000 29.4670000 26.7880000 + 576 576 1 0.0000000 18.7520000 29.4670000 32.1460000 + 577 577 1 0.0000000 24.1090000 2.6790000 5.3580000 + 578 578 1 0.0000000 24.1090000 2.6790000 10.7150000 + 579 579 1 0.0000000 24.1090000 2.6790000 16.0730000 + 580 580 1 0.0000000 24.1090000 2.6790000 21.4310000 + 581 581 1 0.0000000 24.1090000 2.6790000 26.7880000 + 582 582 1 0.0000000 24.1090000 2.6790000 32.1460000 + 583 583 1 0.0000000 24.1090000 8.0360000 5.3580000 + 584 584 1 0.0000000 24.1090000 8.0360000 10.7150000 + 585 585 1 0.0000000 24.1090000 8.0360000 16.0730000 + 586 586 1 0.0000000 24.1090000 8.0360000 21.4310000 + 587 587 1 0.0000000 24.1090000 8.0360000 26.7880000 + 588 588 1 0.0000000 24.1090000 8.0360000 32.1460000 + 589 589 1 0.0000000 24.1090000 13.3940000 5.3580000 + 590 590 1 0.0000000 24.1090000 13.3940000 10.7150000 + 591 591 1 0.0000000 24.1090000 13.3940000 16.0730000 + 592 592 1 0.0000000 24.1090000 13.3940000 21.4310000 + 593 593 1 0.0000000 24.1090000 13.3940000 26.7880000 + 594 594 1 0.0000000 24.1090000 13.3940000 32.1460000 + 595 595 1 0.0000000 24.1090000 18.7520000 5.3580000 + 596 596 1 0.0000000 24.1090000 18.7520000 10.7150000 + 597 597 1 0.0000000 24.1090000 18.7520000 16.0730000 + 598 598 1 0.0000000 24.1090000 18.7520000 21.4310000 + 599 599 1 0.0000000 24.1090000 18.7520000 26.7880000 + 600 600 1 0.0000000 24.1090000 18.7520000 32.1460000 + 601 601 1 0.0000000 24.1090000 24.1090000 5.3580000 + 602 602 1 0.0000000 24.1090000 24.1090000 10.7150000 + 603 603 1 0.0000000 24.1090000 24.1090000 16.0730000 + 604 604 1 0.0000000 24.1090000 24.1090000 21.4310000 + 605 605 1 0.0000000 24.1090000 24.1090000 26.7880000 + 606 606 1 0.0000000 24.1090000 24.1090000 32.1460000 + 607 607 1 0.0000000 24.1090000 29.4670000 5.3580000 + 608 608 1 0.0000000 24.1090000 29.4670000 10.7150000 + 609 609 1 0.0000000 24.1090000 29.4670000 16.0730000 + 610 610 1 0.0000000 24.1090000 29.4670000 21.4310000 + 611 611 1 0.0000000 24.1090000 29.4670000 26.7880000 + 612 612 1 0.0000000 24.1090000 29.4670000 32.1460000 + 613 613 1 0.0000000 29.4670000 2.6790000 5.3580000 + 614 614 1 0.0000000 29.4670000 2.6790000 10.7150000 + 615 615 1 0.0000000 29.4670000 2.6790000 16.0730000 + 616 616 1 0.0000000 29.4670000 2.6790000 21.4310000 + 617 617 1 0.0000000 29.4670000 2.6790000 26.7880000 + 618 618 1 0.0000000 29.4670000 2.6790000 32.1460000 + 619 619 1 0.0000000 29.4670000 8.0360000 5.3580000 + 620 620 1 0.0000000 29.4670000 8.0360000 10.7150000 + 621 621 1 0.0000000 29.4670000 8.0360000 16.0730000 + 622 622 1 0.0000000 29.4670000 8.0360000 21.4310000 + 623 623 1 0.0000000 29.4670000 8.0360000 26.7880000 + 624 624 1 0.0000000 29.4670000 8.0360000 32.1460000 + 625 625 1 0.0000000 29.4670000 13.3940000 5.3580000 + 626 626 1 0.0000000 29.4670000 13.3940000 10.7150000 + 627 627 1 0.0000000 29.4670000 13.3940000 16.0730000 + 628 628 1 0.0000000 29.4670000 13.3940000 21.4310000 + 629 629 1 0.0000000 29.4670000 13.3940000 26.7880000 + 630 630 1 0.0000000 29.4670000 13.3940000 32.1460000 + 631 631 1 0.0000000 29.4670000 18.7520000 5.3580000 + 632 632 1 0.0000000 29.4670000 18.7520000 10.7150000 + 633 633 1 0.0000000 29.4670000 18.7520000 16.0730000 + 634 634 1 0.0000000 29.4670000 18.7520000 21.4310000 + 635 635 1 0.0000000 29.4670000 18.7520000 26.7880000 + 636 636 1 0.0000000 29.4670000 18.7520000 32.1460000 + 637 637 1 0.0000000 29.4670000 24.1090000 5.3580000 + 638 638 1 0.0000000 29.4670000 24.1090000 10.7150000 + 639 639 1 0.0000000 29.4670000 24.1090000 16.0730000 + 640 640 1 0.0000000 29.4670000 24.1090000 21.4310000 + 641 641 1 0.0000000 29.4670000 24.1090000 26.7880000 + 642 642 1 0.0000000 29.4670000 24.1090000 32.1460000 + 643 643 1 0.0000000 29.4670000 29.4670000 5.3580000 + 644 644 1 0.0000000 29.4670000 29.4670000 10.7150000 + 645 645 1 0.0000000 29.4670000 29.4670000 16.0730000 + 646 646 1 0.0000000 29.4670000 29.4670000 21.4310000 + 647 647 1 0.0000000 29.4670000 29.4670000 26.7880000 + 648 648 1 0.0000000 29.4670000 29.4670000 32.1460000 + 649 649 1 0.0000000 0.0000000 5.3580000 5.3580000 + 650 650 1 0.0000000 0.0000000 5.3580000 10.7150000 + 651 651 1 0.0000000 0.0000000 5.3580000 16.0730000 + 652 652 1 0.0000000 0.0000000 5.3580000 21.4310000 + 653 653 1 0.0000000 0.0000000 5.3580000 26.7880000 + 654 654 1 0.0000000 0.0000000 5.3580000 32.1460000 + 655 655 1 0.0000000 0.0000000 10.7150000 5.3580000 + 656 656 1 0.0000000 0.0000000 10.7150000 10.7150000 + 657 657 1 0.0000000 0.0000000 10.7150000 16.0730000 + 658 658 1 0.0000000 0.0000000 10.7150000 21.4310000 + 659 659 1 0.0000000 0.0000000 10.7150000 26.7880000 + 660 660 1 0.0000000 0.0000000 10.7150000 32.1460000 + 661 661 1 0.0000000 0.0000000 16.0730000 5.3580000 + 662 662 1 0.0000000 0.0000000 16.0730000 10.7150000 + 663 663 1 0.0000000 0.0000000 16.0730000 16.0730000 + 664 664 1 0.0000000 0.0000000 16.0730000 21.4310000 + 665 665 1 0.0000000 0.0000000 16.0730000 26.7880000 + 666 666 1 0.0000000 0.0000000 16.0730000 32.1460000 + 667 667 1 0.0000000 0.0000000 21.4310000 5.3580000 + 668 668 1 0.0000000 0.0000000 21.4310000 10.7150000 + 669 669 1 0.0000000 0.0000000 21.4310000 16.0730000 + 670 670 1 0.0000000 0.0000000 21.4310000 21.4310000 + 671 671 1 0.0000000 0.0000000 21.4310000 26.7880000 + 672 672 1 0.0000000 0.0000000 21.4310000 32.1460000 + 673 673 1 0.0000000 0.0000000 26.7880000 5.3580000 + 674 674 1 0.0000000 0.0000000 26.7880000 10.7150000 + 675 675 1 0.0000000 0.0000000 26.7880000 16.0730000 + 676 676 1 0.0000000 0.0000000 26.7880000 21.4310000 + 677 677 1 0.0000000 0.0000000 26.7880000 26.7880000 + 678 678 1 0.0000000 0.0000000 26.7880000 32.1460000 + 679 679 1 0.0000000 0.0000000 32.1460000 5.3580000 + 680 680 1 0.0000000 0.0000000 32.1460000 10.7150000 + 681 681 1 0.0000000 0.0000000 32.1460000 16.0730000 + 682 682 1 0.0000000 0.0000000 32.1460000 21.4310000 + 683 683 1 0.0000000 0.0000000 32.1460000 26.7880000 + 684 684 1 0.0000000 0.0000000 32.1460000 32.1460000 + 685 685 1 0.0000000 5.3580000 5.3580000 5.3580000 + 686 686 1 0.0000000 5.3580000 5.3580000 10.7150000 + 687 687 1 0.0000000 5.3580000 5.3580000 16.0730000 + 688 688 1 0.0000000 5.3580000 5.3580000 21.4310000 + 689 689 1 0.0000000 5.3580000 5.3580000 26.7880000 + 690 690 1 0.0000000 5.3580000 5.3580000 32.1460000 + 691 691 1 0.0000000 5.3580000 10.7150000 5.3580000 + 692 692 1 0.0000000 5.3580000 10.7150000 10.7150000 + 693 693 1 0.0000000 5.3580000 10.7150000 16.0730000 + 694 694 1 0.0000000 5.3580000 10.7150000 21.4310000 + 695 695 1 0.0000000 5.3580000 10.7150000 26.7880000 + 696 696 1 0.0000000 5.3580000 10.7150000 32.1460000 + 697 697 1 0.0000000 5.3580000 16.0730000 5.3580000 + 698 698 1 0.0000000 5.3580000 16.0730000 10.7150000 + 699 699 1 0.0000000 5.3580000 16.0730000 16.0730000 + 700 700 1 0.0000000 5.3580000 16.0730000 21.4310000 + 701 701 1 0.0000000 5.3580000 16.0730000 26.7880000 + 702 702 1 0.0000000 5.3580000 16.0730000 32.1460000 + 703 703 1 0.0000000 5.3580000 21.4310000 5.3580000 + 704 704 1 0.0000000 5.3580000 21.4310000 10.7150000 + 705 705 1 0.0000000 5.3580000 21.4310000 16.0730000 + 706 706 1 0.0000000 5.3580000 21.4310000 21.4310000 + 707 707 1 0.0000000 5.3580000 21.4310000 26.7880000 + 708 708 1 0.0000000 5.3580000 21.4310000 32.1460000 + 709 709 1 0.0000000 5.3580000 26.7880000 5.3580000 + 710 710 1 0.0000000 5.3580000 26.7880000 10.7150000 + 711 711 1 0.0000000 5.3580000 26.7880000 16.0730000 + 712 712 1 0.0000000 5.3580000 26.7880000 21.4310000 + 713 713 1 0.0000000 5.3580000 26.7880000 26.7880000 + 714 714 1 0.0000000 5.3580000 26.7880000 32.1460000 + 715 715 1 0.0000000 5.3580000 32.1460000 5.3580000 + 716 716 1 0.0000000 5.3580000 32.1460000 10.7150000 + 717 717 1 0.0000000 5.3580000 32.1460000 16.0730000 + 718 718 1 0.0000000 5.3580000 32.1460000 21.4310000 + 719 719 1 0.0000000 5.3580000 32.1460000 26.7880000 + 720 720 1 0.0000000 5.3580000 32.1460000 32.1460000 + 721 721 1 0.0000000 10.7150000 5.3580000 5.3580000 + 722 722 1 0.0000000 10.7150000 5.3580000 10.7150000 + 723 723 1 0.0000000 10.7150000 5.3580000 16.0730000 + 724 724 1 0.0000000 10.7150000 5.3580000 21.4310000 + 725 725 1 0.0000000 10.7150000 5.3580000 26.7880000 + 726 726 1 0.0000000 10.7150000 5.3580000 32.1460000 + 727 727 1 0.0000000 10.7150000 10.7150000 5.3580000 + 728 728 1 0.0000000 10.7150000 10.7150000 10.7150000 + 729 729 1 0.0000000 10.7150000 10.7150000 16.0730000 + 730 730 1 0.0000000 10.7150000 10.7150000 21.4310000 + 731 731 1 0.0000000 10.7150000 10.7150000 26.7880000 + 732 732 1 0.0000000 10.7150000 10.7150000 32.1460000 + 733 733 1 0.0000000 10.7150000 16.0730000 5.3580000 + 734 734 1 0.0000000 10.7150000 16.0730000 10.7150000 + 735 735 1 0.0000000 10.7150000 16.0730000 16.0730000 + 736 736 1 0.0000000 10.7150000 16.0730000 21.4310000 + 737 737 1 0.0000000 10.7150000 16.0730000 26.7880000 + 738 738 1 0.0000000 10.7150000 16.0730000 32.1460000 + 739 739 1 0.0000000 10.7150000 21.4310000 5.3580000 + 740 740 1 0.0000000 10.7150000 21.4310000 10.7150000 + 741 741 1 0.0000000 10.7150000 21.4310000 16.0730000 + 742 742 1 0.0000000 10.7150000 21.4310000 21.4310000 + 743 743 1 0.0000000 10.7150000 21.4310000 26.7880000 + 744 744 1 0.0000000 10.7150000 21.4310000 32.1460000 + 745 745 1 0.0000000 10.7150000 26.7880000 5.3580000 + 746 746 1 0.0000000 10.7150000 26.7880000 10.7150000 + 747 747 1 0.0000000 10.7150000 26.7880000 16.0730000 + 748 748 1 0.0000000 10.7150000 26.7880000 21.4310000 + 749 749 1 0.0000000 10.7150000 26.7880000 26.7880000 + 750 750 1 0.0000000 10.7150000 26.7880000 32.1460000 + 751 751 1 0.0000000 10.7150000 32.1460000 5.3580000 + 752 752 1 0.0000000 10.7150000 32.1460000 10.7150000 + 753 753 1 0.0000000 10.7150000 32.1460000 16.0730000 + 754 754 1 0.0000000 10.7150000 32.1460000 21.4310000 + 755 755 1 0.0000000 10.7150000 32.1460000 26.7880000 + 756 756 1 0.0000000 10.7150000 32.1460000 32.1460000 + 757 757 1 0.0000000 16.0730000 5.3580000 5.3580000 + 758 758 1 0.0000000 16.0730000 5.3580000 10.7150000 + 759 759 1 0.0000000 16.0730000 5.3580000 16.0730000 + 760 760 1 0.0000000 16.0730000 5.3580000 21.4310000 + 761 761 1 0.0000000 16.0730000 5.3580000 26.7880000 + 762 762 1 0.0000000 16.0730000 5.3580000 32.1460000 + 763 763 1 0.0000000 16.0730000 10.7150000 5.3580000 + 764 764 1 0.0000000 16.0730000 10.7150000 10.7150000 + 765 765 1 0.0000000 16.0730000 10.7150000 16.0730000 + 766 766 1 0.0000000 16.0730000 10.7150000 21.4310000 + 767 767 1 0.0000000 16.0730000 10.7150000 26.7880000 + 768 768 1 0.0000000 16.0730000 10.7150000 32.1460000 + 769 769 1 0.0000000 16.0730000 16.0730000 5.3580000 + 770 770 1 0.0000000 16.0730000 16.0730000 10.7150000 + 771 771 1 0.0000000 16.0730000 16.0730000 16.0730000 + 772 772 1 0.0000000 16.0730000 16.0730000 21.4310000 + 773 773 1 0.0000000 16.0730000 16.0730000 26.7880000 + 774 774 1 0.0000000 16.0730000 16.0730000 32.1460000 + 775 775 1 0.0000000 16.0730000 21.4310000 5.3580000 + 776 776 1 0.0000000 16.0730000 21.4310000 10.7150000 + 777 777 1 0.0000000 16.0730000 21.4310000 16.0730000 + 778 778 1 0.0000000 16.0730000 21.4310000 21.4310000 + 779 779 1 0.0000000 16.0730000 21.4310000 26.7880000 + 780 780 1 0.0000000 16.0730000 21.4310000 32.1460000 + 781 781 1 0.0000000 16.0730000 26.7880000 5.3580000 + 782 782 1 0.0000000 16.0730000 26.7880000 10.7150000 + 783 783 1 0.0000000 16.0730000 26.7880000 16.0730000 + 784 784 1 0.0000000 16.0730000 26.7880000 21.4310000 + 785 785 1 0.0000000 16.0730000 26.7880000 26.7880000 + 786 786 1 0.0000000 16.0730000 26.7880000 32.1460000 + 787 787 1 0.0000000 16.0730000 32.1460000 5.3580000 + 788 788 1 0.0000000 16.0730000 32.1460000 10.7150000 + 789 789 1 0.0000000 16.0730000 32.1460000 16.0730000 + 790 790 1 0.0000000 16.0730000 32.1460000 21.4310000 + 791 791 1 0.0000000 16.0730000 32.1460000 26.7880000 + 792 792 1 0.0000000 16.0730000 32.1460000 32.1460000 + 793 793 1 0.0000000 21.4310000 5.3580000 5.3580000 + 794 794 1 0.0000000 21.4310000 5.3580000 10.7150000 + 795 795 1 0.0000000 21.4310000 5.3580000 16.0730000 + 796 796 1 0.0000000 21.4310000 5.3580000 21.4310000 + 797 797 1 0.0000000 21.4310000 5.3580000 26.7880000 + 798 798 1 0.0000000 21.4310000 5.3580000 32.1460000 + 799 799 1 0.0000000 21.4310000 10.7150000 5.3580000 + 800 800 1 0.0000000 21.4310000 10.7150000 10.7150000 + 801 801 1 0.0000000 21.4310000 10.7150000 16.0730000 + 802 802 1 0.0000000 21.4310000 10.7150000 21.4310000 + 803 803 1 0.0000000 21.4310000 10.7150000 26.7880000 + 804 804 1 0.0000000 21.4310000 10.7150000 32.1460000 + 805 805 1 0.0000000 21.4310000 16.0730000 5.3580000 + 806 806 1 0.0000000 21.4310000 16.0730000 10.7150000 + 807 807 1 0.0000000 21.4310000 16.0730000 16.0730000 + 808 808 1 0.0000000 21.4310000 16.0730000 21.4310000 + 809 809 1 0.0000000 21.4310000 16.0730000 26.7880000 + 810 810 1 0.0000000 21.4310000 16.0730000 32.1460000 + 811 811 1 0.0000000 21.4310000 21.4310000 5.3580000 + 812 812 1 0.0000000 21.4310000 21.4310000 10.7150000 + 813 813 1 0.0000000 21.4310000 21.4310000 16.0730000 + 814 814 1 0.0000000 21.4310000 21.4310000 21.4310000 + 815 815 1 0.0000000 21.4310000 21.4310000 26.7880000 + 816 816 1 0.0000000 21.4310000 21.4310000 32.1460000 + 817 817 1 0.0000000 21.4310000 26.7880000 5.3580000 + 818 818 1 0.0000000 21.4310000 26.7880000 10.7150000 + 819 819 1 0.0000000 21.4310000 26.7880000 16.0730000 + 820 820 1 0.0000000 21.4310000 26.7880000 21.4310000 + 821 821 1 0.0000000 21.4310000 26.7880000 26.7880000 + 822 822 1 0.0000000 21.4310000 26.7880000 32.1460000 + 823 823 1 0.0000000 21.4310000 32.1460000 5.3580000 + 824 824 1 0.0000000 21.4310000 32.1460000 10.7150000 + 825 825 1 0.0000000 21.4310000 32.1460000 16.0730000 + 826 826 1 0.0000000 21.4310000 32.1460000 21.4310000 + 827 827 1 0.0000000 21.4310000 32.1460000 26.7880000 + 828 828 1 0.0000000 21.4310000 32.1460000 32.1460000 + 829 829 1 0.0000000 26.7880000 5.3580000 5.3580000 + 830 830 1 0.0000000 26.7880000 5.3580000 10.7150000 + 831 831 1 0.0000000 26.7880000 5.3580000 16.0730000 + 832 832 1 0.0000000 26.7880000 5.3580000 21.4310000 + 833 833 1 0.0000000 26.7880000 5.3580000 26.7880000 + 834 834 1 0.0000000 26.7880000 5.3580000 32.1460000 + 835 835 1 0.0000000 26.7880000 10.7150000 5.3580000 + 836 836 1 0.0000000 26.7880000 10.7150000 10.7150000 + 837 837 1 0.0000000 26.7880000 10.7150000 16.0730000 + 838 838 1 0.0000000 26.7880000 10.7150000 21.4310000 + 839 839 1 0.0000000 26.7880000 10.7150000 26.7880000 + 840 840 1 0.0000000 26.7880000 10.7150000 32.1460000 + 841 841 1 0.0000000 26.7880000 16.0730000 5.3580000 + 842 842 1 0.0000000 26.7880000 16.0730000 10.7150000 + 843 843 1 0.0000000 26.7880000 16.0730000 16.0730000 + 844 844 1 0.0000000 26.7880000 16.0730000 21.4310000 + 845 845 1 0.0000000 26.7880000 16.0730000 26.7880000 + 846 846 1 0.0000000 26.7880000 16.0730000 32.1460000 + 847 847 1 0.0000000 26.7880000 21.4310000 5.3580000 + 848 848 1 0.0000000 26.7880000 21.4310000 10.7150000 + 849 849 1 0.0000000 26.7880000 21.4310000 16.0730000 + 850 850 1 0.0000000 26.7880000 21.4310000 21.4310000 + 851 851 1 0.0000000 26.7880000 21.4310000 26.7880000 + 852 852 1 0.0000000 26.7880000 21.4310000 32.1460000 + 853 853 1 0.0000000 26.7880000 26.7880000 5.3580000 + 854 854 1 0.0000000 26.7880000 26.7880000 10.7150000 + 855 855 1 0.0000000 26.7880000 26.7880000 16.0730000 + 856 856 1 0.0000000 26.7880000 26.7880000 21.4310000 + 857 857 1 0.0000000 26.7880000 26.7880000 26.7880000 + 858 858 1 0.0000000 26.7880000 26.7880000 32.1460000 + 859 859 1 0.0000000 26.7880000 32.1460000 5.3580000 + 860 860 1 0.0000000 26.7880000 32.1460000 10.7150000 + 861 861 1 0.0000000 26.7880000 32.1460000 16.0730000 + 862 862 1 0.0000000 26.7880000 32.1460000 21.4310000 + 863 863 1 0.0000000 26.7880000 32.1460000 26.7880000 + 864 864 1 0.0000000 26.7880000 32.1460000 32.1460000 + diff --git a/examples/python/gjf_python/ff-argon.lmp b/examples/python/gjf_python/ff-argon.lmp new file mode 100644 index 0000000000..b6f7bc931a --- /dev/null +++ b/examples/python/gjf_python/ff-argon.lmp @@ -0,0 +1,20 @@ +############################# +#Atoms types - mass - charge# +############################# +#@ 1 atom types #!THIS LINE IS NECESSARY DON'T SPEND HOURS FINDING THAT OUT!# + +variable Ar equal 1 + +############# +#Atom Masses# +############# + +mass ${Ar} 39.903 + +########################### +#Pair Potentials - Tersoff# +########################### + +pair_style lj/cubic +pair_coeff * * 0.0102701 3.42 + diff --git a/examples/python/gjf_python/gjf.py b/examples/python/gjf_python/gjf.py new file mode 100644 index 0000000000..37fc28bb79 --- /dev/null +++ b/examples/python/gjf_python/gjf.py @@ -0,0 +1,180 @@ +"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" + +from mpi4py import MPI +from lammps import lammps +import lammps_tools as lt +import numpy as np + +comm = MPI.COMM_WORLD +rank = comm.Get_rank() + +""" LAMMPS VARIABLES """ + +# new file or restart +run_no = 0 + +# data files +infile = "argon.lmp" +restart_file = "final_restart.{}".format(run_no) +ff_file = "ff-argon.lmp" +outfile = "output.dat" + +# write final_restart +write_final_restart = False + +# random numbers +seed0 = 2357 +seed1 = 26588 +seed2 = 10669 + +# MD Parameters +# number of steps +nsteps = 50000 +# timestep +# dt = 0.001 +# starting simulation temp +temp_start = 10 +# final simulation temp +temp_final = 10 +# relaxation time +trel = 1 +# trajectory frequency +ntraj = 0 + +# Ensemble 0 = GJF u, 1 = GJF v, 2 = Nose-Hoover, 3 = Langevin, 4 = BDP (Currently all NVT) +ensemble = 0 + +# Output Parameters +nthermo = 200 +nout = int(nsteps / nthermo) # Important + +# output to screen and log file? +lammps_output = False +# Lammps Thermo +thermo = False + +python_output = True + +# Write output to file? +write_output = False + +if write_output is True: + data = open("{}".format(outfile), "w") + +if python_output is True: + if rank == 0: + print("dt, temp, ke, fke, pe, fpe") + +for j in range(20): + + # timestep + dt = 0.005*(j+1) + + if lammps_output is True: + lmp = lammps() + else: + lmp = lammps(cmdargs=["-screen", "none", "-log", "none"]) + + lmp.command("atom_style full") + lmp.command("units metal") + lmp.command("processors * * *") + lmp.command("neighbor 1 bin") + lmp.command("boundary p p p") + + if run_no is 0: + lmp.command("read_data {}".format(infile)) + else: + lmp.command("read_restart final_restart".format(run_no-1)) + + if thermo is True: + lmp.command("thermo_style custom time temp pe ke press vol cpu") + lmp.command("thermo {}".format(nthermo)) + lmp.command("thermo_modify flush yes") + + lmp.file("{}".format(ff_file)) + lmp.command("timestep {}".format(dt)) + + # get_per_atom_compute example with dim of two and within a group + # lmp.command("region rand block 5 20 5 20 5 20") + # lmp.command("group rand region rand") + # lmp.command("compute x rand property/atom x y") + # test = get_per_atom_compute(comm, lmp, "x", 2, group="rand") + + lmp.command("compute ke all ke/atom") + + lmp.command("compute pe all pe") + + if ntraj != 0: + lmp.command("dump 1 all dcd {} trajectory.dcd".format(ntraj)) + lmp.command("dump_modify 1 unwrap yes") + + if run_no == 0: + lmp.command("velocity all create {} {} mom yes dist gaussian".format(temp_start, seed0)) + lmp.command("fix nve all nve") + + if ensemble == 0: + # gjf u + lmp.command("fix lang all langevin {} {} {} {} gjf yes halfstep yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 1: + # gjf v + lmp.command("fix lang all langevin {} {} {} {} gjf yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 2: + # NH + lmp.command("fix nvt all nvt temp {} {} {}".format( + temp_start, temp_final, trel)) + elif ensemble == 3: + # lang + lmp.command("fix lang all langevin {} {} {} {} tally yes zero yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 4: + # BDP + lmp.command("fix stoch all temp/csvr {} {} {} {}".format( + temp_start, temp_final, trel, seed1)) + + natoms = lmp.extract_global("natoms", 0) + nlocal = lmp.extract_global("nlocal", 0) + ke_sum = lt.get_per_atom_compute(comm, lmp, "ke") + ke_2 = ke_sum**2 + pe_sum = 0 + pe_2 = 0 + temp_sum = 0 + + for i in range(nout): + nlocal = lmp.extract_global("nlocal", 0) + lmp.command("run {} pre no post no".format(nthermo)) + temp = lmp.extract_compute("thermo_temp", 0, 0) + ke = lt.get_per_atom_compute(comm, lmp, "ke") + pe = lmp.extract_compute("pe", 0, 0) + ke_sum += ke + ke_2 += ke**2 + pe_sum += pe + pe_2 += pe**2 + temp_sum += temp + + if python_output is True: + if rank == 0: + print("Time: {:.6f}, Temp: {:.6f}, KE: {:.6f}, PE: {:.6f}".format( + i*nthermo*dt, temp, ke.sum(), pe)) + + if write_final_restart is True: + lmp.command("write_restart {}".format(restart_file)) + + if rank == 0: + ke = ke_sum.sum() / (nout + 1) + fke = (np.sqrt((ke_2 - ke_sum ** 2 / (nout + 1)) / (nout + 1))).sum() + pe = pe_sum / nout + fpe = np.sqrt((pe_2 - pe_sum ** 2 / nout) / nout) + temp = temp_sum / nout + + if python_output is True: + print(dt, temp, ke, fke, pe, fpe) + + if write_output is True: + data.write("{:.6f} {:.6f} {:.6f} {:.6f} {:.6f} {:.6f}\n".format( + dt, temp, ke, fke, pe, fpe)) + data.flush() + +if write_output is True: + data.close() diff --git a/examples/python/gjf_python/lammps_tools.py b/examples/python/gjf_python/lammps_tools.py new file mode 100644 index 0000000000..f9f25eaa28 --- /dev/null +++ b/examples/python/gjf_python/lammps_tools.py @@ -0,0 +1,78 @@ +"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" + +from mpi4py import MPI +import numpy as np +import ctypes as ctypes + +""" USEFULL LAMMPS FUNCTION """ + + +def get_nlocal(lmp): + + nlocal = lmp.extract_global("nlocal", 0) + + return nlocal + + +def get_aid(lmp, group=None): + + if group is None: + c_aid = lmp.extract_atom("id", 0) + ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_int32 * get_nlocal(lmp))) + aid = np.frombuffer(ptr.contents, dtype=np.int32) + else: + try: + c_aid = lmp.extract_variable("aid", group, 1) + ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_double * get_nlocal(lmp))) + aid = np.frombuffer(ptr.contents, dtype=np.double) + except ValueError: + lmp.command("variable aid atom id") + aid = get_aid(lmp, group) + + return aid + + +def get_per_atom_compute(comm, lmp, name, dim=1, dtype="double", group=None): + laid = get_aid(lmp, group) + nlocal = get_nlocal(lmp) + ngroup = comm.allgather(laid) + type = dim + if dim > 1: + type = 2 + for array in ngroup: + try: + aid = np.concatenate((aid, array)) + except UnboundLocalError: + aid = array + if dtype == "double": + mem_type = ctypes.c_double + elif dtype == "integer": + mem_type = ctypes.c_int + elif dtype == "bigint": + mem_type = ctypes.c_int32 + else: + print("{} not implemented".format(dtype)) + return + + tmp = lmp.extract_compute(name, 1, type) + if type == 1: + ptr = ctypes.cast(tmp, ctypes.POINTER(mem_type * nlocal)) + else: + ptr = ctypes.cast(tmp[0], ctypes.POINTER(mem_type * nlocal * dim)) + lcompute = comm.allgather(np.frombuffer(ptr.contents).reshape((-1, dim))) + for array in lcompute: + try: + compute = np.concatenate((compute, array)) + except UnboundLocalError: + compute = array + + aid = np.expand_dims(aid, axis=1) + + compute = np.concatenate((aid, compute), axis=-1) + compute = compute[compute[..., 0] != 0] + compute = compute[compute[..., 0].argsort()][..., 1:] + + if dim == 1: + compute = np.squeeze(compute, axis=-1) + + return compute \ No newline at end of file From e517a16bdae1b1b3b1064b39f9a663d5900faff6 Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 17:21:01 -0700 Subject: [PATCH 053/557] updated gjf in fix_langevin --- src/fix_langevin.cpp | 39 +++++++++++---------------------------- src/fix_langevin.h | 2 +- 2 files changed, 12 insertions(+), 29 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 5058d5c650..840861ef91 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -174,11 +174,11 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { - int mem = 6*atom->nmax*sizeof(double); - if (hsflag) mem += 3*atom->nmax*sizeof(double); - - comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); - comm->maxexchange_fix += MAX(1000, mem); + //int mem = 6*atom->nmax*sizeof(double); + //if (hsflag) mem += 3*atom->nmax*sizeof(double); +// + //comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); + //comm->maxexchange_fix += MAX(1000, mem); nvalues = 3; grow_arrays(atom->nmax); @@ -232,7 +232,6 @@ FixLangevin::~FixLangevin() int FixLangevin::setmask() { int mask = 0; - //if (gjfflag) mask |= INITIAL_INTEGRATE; if (gjfflag) mask |= POST_INTEGRATE; mask |= POST_FORCE; mask |= POST_FORCE_RESPA; @@ -321,35 +320,19 @@ void FixLangevin::setup(int vflag) post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); } - if (gjfflag && hsflag) { + if (gjfflag) { - double dt = update->dt; // update v of atoms in group - - double **v = atom->v; - double *rmass = atom->rmass; - int *type = atom->type; + double ** v = atom->v; + double **f = atom->f; int nlocal = atom->nlocal; if (igroup == atom->firstgroup) nlocal = atom->nfirst; - double boltz = force->boltz; - double mvv2e = force->mvv2e; - double ftm2v = force->ftm2v; - - double gamma2; - for (int i = 0; i < nlocal; i++) { - if (rmass) { - gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; - gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; - } else { - gamma2 = gfactor2[type[i]] * tsqrt; - } - - franprev[i][0] = gamma2*random->gaussian(); - franprev[i][1] = gamma2*random->gaussian(); - franprev[i][2] = gamma2*random->gaussian(); + f[i][0] = wildcard[i][0]; + f[i][1] = wildcard[i][1]; + f[i][2] = wildcard[i][2]; wildcard[i][0] = v[i][0]; wildcard[i][1] = v[i][1]; wildcard[i][2] = v[i][2]; diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 70fb254f4e..91ed210e54 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -65,7 +65,7 @@ class FixLangevin : public Fix { double **flangevin; double *tforce; double **franprev; - double **lv; //lucas velocity or half-step velocity + double **lv; //2GJ velocity or half-step velocity double **wildcard; int nvalues; From 473e64c6b6d2c2ac86db5672075febd12af4385c Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 13:49:41 +0000 Subject: [PATCH 054/557] actual gradient of energy, not scaled by hbar. convergence criterion is in eV --- src/SPIN/min_spin_oso_lbfgs.cpp | 10 ++++------ 1 file changed, 4 insertions(+), 6 deletions(-) diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 8d05ea63d8..d7e7302e4f 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -313,16 +313,14 @@ void MinSpinOSO_LBFGS::calc_gradient() int nlocal = atom->nlocal; double **sp = atom->sp; double **fm = atom->fm; + double hbar = force->hplanck/MY_2PI; // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - - // calculate gradients - - g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * hbar; + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * hbar; + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * hbar; } } From e4001b01791e9ac1caa54d0c5962886f566afa18 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 14:38:02 +0000 Subject: [PATCH 055/557] change convergence criterion --- src/SPIN/min_spin_oso_cg.cpp | 49 +++++++++++++++++++----------------- src/SPIN/min_spin_oso_cg.h | 10 ++++---- 2 files changed, 31 insertions(+), 28 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index d8535b19c4..fe52ddebe1 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -66,6 +66,8 @@ MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); nlocal_max = 0; + alpha_damp = 1.0; + discrete_factor = 10.0; } /* ---------------------------------------------------------------------- */ @@ -81,11 +83,9 @@ MinSpinOSO_CG::~MinSpinOSO_CG() void MinSpinOSO_CG::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; + local_iter = 0; Min::init(); - dts = dt = update->dt; last_negative = update->ntimestep; @@ -216,7 +216,7 @@ int MinSpinOSO_CG::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fmdotfm = fmnorm_sqr(); + fmdotfm = max_torque(); if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -393,38 +393,41 @@ void MinSpinOSO_CG::advance_spins() } /* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 + compute and return max_i||mag. torque_i||_2 ------------------------------------------------------------------------- */ -double MinSpinOSO_CG::fmnorm_sqr() +double MinSpinOSO_CG::max_torque() { + double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; int nlocal = atom->nlocal; - double tx,ty,tz; - double **sp = atom->sp; - double **fm = atom->fm; + double hbar = force->hplanck/MY_2PI; - // calc. magnetic torques + // finding max fm on this proc. - double local_norm2_sqr = 0.0; + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; for (int i = 0; i < nlocal; i++) { - tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - local_norm2_sqr += tx*tx + ty*ty + tz*tz; + fmsq = 0.0; + for (int j = 0; j < 3; j++) + fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; + fmaxsqone = MAX(fmaxsqone,fmsq); } - // no extra atom calc. for spins + // finding max fm on this replica - if (nextra_atom) - error->all(FLERR,"extra atom option not available yet"); + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - double norm2_sqr = 0.0; - MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas - return norm2_sqr; + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + return sqrt(fmaxsqall) * hbar; } - /* ---------------------------------------------------------------------- calculate 3x3 matrix exponential using Rodrigues' formula (R. Murray, Z. Li, and S. Shankar Sastry, diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index 3a3d24f078..81bbd2c294 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -25,8 +25,7 @@ MinimizeStyle(spin/oso_cg, MinSpinOSO_CG) namespace LAMMPS_NS { class MinSpinOSO_CG : public Min { - -public: + public: MinSpinOSO_CG(class LAMMPS *); virtual ~MinSpinOSO_CG(); void init(); @@ -34,18 +33,19 @@ public: int modify_param(int, char **); void reset_vectors(); int iterate(int); + + private: double evaluate_dt(); void advance_spins(); - double fmnorm_sqr(); + double max_torque(); void calc_gradient(double); void calc_search_direction(); -private: // global and spin timesteps - int nlocal_max; // max value of nlocal (for size of lists) double dt; double dts; + int nlocal_max; // max value of nlocal (for size of lists) double alpha_damp; // damping for spin minimization double discrete_factor; // factor for spin timestep evaluation From fabe611c110b1366088369b9e8c5eb56f50aaf04 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 17:26:47 +0000 Subject: [PATCH 056/557] use line search or adaptive time step --- src/SPIN/min_spin_oso_cg.cpp | 3 +- src/SPIN/min_spin_oso_cg2.cpp | 98 ++++++++++++++++++++--------------- src/SPIN/min_spin_oso_cg2.h | 4 ++ 3 files changed, 62 insertions(+), 43 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index fe52ddebe1..8eb358f86a 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -151,7 +151,7 @@ void MinSpinOSO_CG::reset_vectors() } /* ---------------------------------------------------------------------- - minimization via damped spin dynamics + minimization via orthogonal spin optimisation ------------------------------------------------------------------------- */ int MinSpinOSO_CG::iterate(int maxiter) @@ -428,6 +428,7 @@ double MinSpinOSO_CG::max_torque() return sqrt(fmaxsqall) * hbar; } + /* ---------------------------------------------------------------------- calculate 3x3 matrix exponential using Rodrigues' formula (R. Murray, Z. Li, and S. Shankar Sastry, diff --git a/src/SPIN/min_spin_oso_cg2.cpp b/src/SPIN/min_spin_oso_cg2.cpp index 23873e24f2..52b98eead7 100644 --- a/src/SPIN/min_spin_oso_cg2.cpp +++ b/src/SPIN/min_spin_oso_cg2.cpp @@ -75,7 +75,7 @@ MinSpinOSO_CG2::MinSpinOSO_CG2(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; use_line_search = 1; - maxepsrot = MY_2PI / (100.0); + discrete_factor = 10.0; } @@ -100,6 +100,7 @@ void MinSpinOSO_CG2::init() Min::init(); + dts = dt = update->dt; last_negative = update->ntimestep; // allocate tables @@ -140,9 +141,7 @@ int MinSpinOSO_CG2::modify_param(int narg, char **arg) } if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - double discrete_factor; discrete_factor = force->numeric(FLERR,arg[1]); - maxepsrot = MY_2PI / discrete_factor; return 2; } return 0; @@ -169,7 +168,7 @@ void MinSpinOSO_CG2::reset_vectors() } /* ---------------------------------------------------------------------- - minimization via damped spin dynamics + minimization via orthogonal spin optimisation ------------------------------------------------------------------------- */ int MinSpinOSO_CG2::iterate(int maxiter) @@ -305,20 +304,21 @@ void MinSpinOSO_CG2::calc_gradient() double **sp = atom->sp; double **fm = atom->fm; double hbar = force->hplanck/MY_2PI; + double factor; + + if (use_line_search) + factor = hbar; + else factor = evaluate_dt(); // loop on all spins on proc. for (int i = 0; i < nlocal; i++) { - - // calculate gradients - - g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * hbar; - g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * hbar; - g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * hbar; + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * factor; + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * factor; + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * factor; } } - /* ---------------------------------------------------------------------- search direction: The Fletcher-Reeves conj. grad. method @@ -335,14 +335,10 @@ void MinSpinOSO_CG2::calc_search_direction() double g2_global = 0.0; double g2old_global = 0.0; - double scaling = 1.0; - - if (use_line_search == 0) - scaling = maximum_rotation(g_cur); if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i] * scaling; + p_s[i] = -g_cur[i]; g_old[i] = g_cur[i]; } } else { // conjugate direction @@ -352,11 +348,10 @@ void MinSpinOSO_CG2::calc_search_direction() } // now we need to collect/broadcast beta on this replica - // different replica can have different beta for now. // need to check what is beta for GNEB - MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); - MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); + MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); // Sum over all replicas. Good for GNEB. if (update->multireplica == 1) { @@ -365,12 +360,11 @@ void MinSpinOSO_CG2::calc_search_direction() MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } - if (fabs(g2_global) < 1.0e-60) beta = 0.0; else beta = g2_global / g2old_global; // calculate conjugate direction for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = (beta * p_s[i] - g_cur[i])*scaling; + p_s[i] = (beta * p_s[i] - g_cur[i]); g_old[i] = g_cur[i]; } } @@ -411,6 +405,11 @@ double MinSpinOSO_CG2::max_torque() { double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; int nlocal = atom->nlocal; + double factor; + double hbar = force->hplanck/MY_2PI; + + if (use_line_search) factor = 1.0; + else factor = hbar; // finding max fm on this proc. @@ -436,7 +435,7 @@ double MinSpinOSO_CG2::max_torque() MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); } - return sqrt(fmaxsqall); + return sqrt(fmaxsqall) * factor; } /* ---------------------------------------------------------------------- @@ -607,8 +606,6 @@ int MinSpinOSO_CG2::calc_and_make_step(double a, double b, int index) if (alpha < 0.0) alpha = r/2.0; - std::cout << alpha << "\n"; - for (int i = 0; i < nlocal; i++) { for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; } @@ -636,30 +633,47 @@ int MinSpinOSO_CG2::awc(double der_phi_0, double phi_0, double der_phi_j, double return 0; } -double MinSpinOSO_CG2::maximum_rotation(double *p) +/* ---------------------------------------------------------------------- + evaluate max timestep +---------------------------------------------------------------------- */ + +double MinSpinOSO_CG2::evaluate_dt() { - double norm2,norm2_global,scaling,alpha; + double dtmax; + double fmsq; + double fmaxsqone,fmaxsqloc,fmaxsqall; int nlocal = atom->nlocal; - int ntotal = 0; + double **fm = atom->fm; - norm2 = 0.0; - for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; + // finding max fm on this proc. - MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { - norm2 = norm2_global; - MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); - if (update->multireplica == 1) { - nlocal = ntotal; - MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; + fmaxsqone = MAX(fmaxsqone,fmsq); } - scaling = (maxepsrot * sqrt((double) ntotal / norm2_global)); + // finding max fm on this replica - if (scaling < 1.0) alpha = scaling; - else alpha = 1.0; + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - return alpha; + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + if (fmaxsqall == 0.0) + error->all(FLERR,"Incorrect fmaxsqall calculation"); + + // define max timestep by dividing by the + // inverse of max frequency by discrete_factor + + dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); + + return dtmax; } \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_cg2.h b/src/SPIN/min_spin_oso_cg2.h index c96e82ca8e..83605f98ed 100644 --- a/src/SPIN/min_spin_oso_cg2.h +++ b/src/SPIN/min_spin_oso_cg2.h @@ -34,6 +34,8 @@ class MinSpinOSO_CG2: public Min { void reset_vectors(); int iterate(int); private: + double dt; // global timestep + double dts; // spin timestep int ireplica,nreplica; // for neb double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector @@ -43,7 +45,9 @@ class MinSpinOSO_CG2: public Min { double **sp_copy; // copy of the spins int local_iter; // for neb int nlocal_max; // max value of nlocal (for size of lists) + double discrete_factor; // factor for spin timestep evaluation + double evaluate_dt(); void advance_spins(); void calc_gradient(); void calc_search_direction(); From 31d2b23f9c8de272051beac63261278bcd6bf411 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 17:53:02 +0000 Subject: [PATCH 057/557] rename cg2 -> cg --- src/SPIN/min_spin_oso_cg.cpp | 660 ++++++++++++++++++++------------- src/SPIN/min_spin_oso_cg.h | 43 +-- src/SPIN/min_spin_oso_cg2.cpp | 679 ---------------------------------- src/SPIN/min_spin_oso_cg2.h | 72 ---- 4 files changed, 435 insertions(+), 1019 deletions(-) delete mode 100644 src/SPIN/min_spin_oso_cg2.cpp delete mode 100644 src/SPIN/min_spin_oso_cg2.h diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 8eb358f86a..c9f3a59f87 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -38,6 +38,7 @@ #include "modify.h" #include "math_special.h" #include "math_const.h" +#include "universe.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -61,12 +62,18 @@ static const char cite_minstyle_spin_oso_cg[] = /* ---------------------------------------------------------------------- */ -MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : +MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL) { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); nlocal_max = 0; - alpha_damp = 1.0; + + // nreplica = number of partitions + // ireplica = which world I am in universe + + nreplica = universe->nworlds; + ireplica = universe->iworld; + use_line_search = 1; discrete_factor = 10.0; } @@ -77,24 +84,31 @@ MinSpinOSO_CG::~MinSpinOSO_CG() memory->destroy(g_old); memory->destroy(g_cur); memory->destroy(p_s); + if (use_line_search) + memory->destroy(sp_copy); } /* ---------------------------------------------------------------------- */ void MinSpinOSO_CG::init() { - local_iter = 0; + der_e_cur = 0.0; + der_e_pr = 0.0; + Min::init(); + dts = dt = update->dt; last_negative = update->ntimestep; - + // allocate tables nlocal_max = atom->nlocal; memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg:sp_copy"); } /* ---------------------------------------------------------------------- */ @@ -117,9 +131,9 @@ void MinSpinOSO_CG::setup_style() int MinSpinOSO_CG::modify_param(int narg, char **arg) { - if (strcmp(arg[0],"alpha_damp") == 0) { + if (strcmp(arg[0],"line_search") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - alpha_damp = force->numeric(FLERR,arg[1]); + use_line_search = force->numeric(FLERR,arg[1]); return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { @@ -160,19 +174,22 @@ int MinSpinOSO_CG::iterate(int maxiter) bigint ntimestep; double fmdotfm; int flag, flagall; - - // grow tables if nlocal increased + double **sp = atom->sp; + double der_e_cur_tmp = 0.0; if (nlocal_max < nlocal) { + nlocal_max = nlocal; local_iter = 0; nlocal_max = nlocal; memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + if (use_line_search) + memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg:sp_copy"); } for (int iter = 0; iter < maxiter; iter++) { - + if (timer->check_timeout(niter)) return TIMEOUT; @@ -182,16 +199,51 @@ int MinSpinOSO_CG::iterate(int maxiter) // optimize timestep accross processes / replicas // need a force calculation for timestep optimization - if (local_iter == 0) energy_force(0); - dts = evaluate_dt(); - - calc_gradient(dts); - calc_search_direction(); - advance_spins(); - - eprevious = ecurrent; - ecurrent = energy_force(0); - neval++; + if (use_line_search) { + + // here we need to do line search + if (local_iter == 0) + calc_gradient(); + + calc_search_direction(); + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) + der_e_cur += g_cur[i] * p_s[i]; + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + for (int i = 0; i < nlocal; i++) + for (int j = 0; j < 3; j++) + sp_copy[i][j] = sp[i][j]; + + eprevious = ecurrent; + der_e_pr = der_e_cur; + calc_and_make_step(0.0, 1.0, 0); + } + else{ + + // here we don't do line search + // but use cutoff rotation angle + // if gneb calc., nreplica > 1 + // then calculate gradients and advance spins + // of intermediate replicas only + + if (nreplica > 1) { + if(ireplica != 0 && ireplica != nreplica-1) + calc_gradient(); + calc_search_direction(); + advance_spins(); + } else{ + calc_gradient(); + calc_search_direction(); + advance_spins(); + } + eprevious = ecurrent; + ecurrent = energy_force(0); + neval++; + } //// energy tolerance criterion //// only check after DELAYSTEP elapsed since velocties reset to 0 @@ -239,6 +291,347 @@ int MinSpinOSO_CG::iterate(int maxiter) return MAXITER; } +/* ---------------------------------------------------------------------- + calculate gradients +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG::calc_gradient() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double hbar = force->hplanck/MY_2PI; + double factor; + + if (use_line_search) + factor = hbar; + else factor = evaluate_dt(); + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * factor; + g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * factor; + g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * factor; + } +} + +/* ---------------------------------------------------------------------- + search direction: + The Fletcher-Reeves conj. grad. method + See Jorge Nocedal and Stephen J. Wright 'Numerical + Optimization' Second Edition, 2006 (p. 121) +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG::calc_search_direction() +{ + int nlocal = atom->nlocal; + double g2old = 0.0; + double g2 = 0.0; + double beta = 0.0; + + double g2_global = 0.0; + double g2old_global = 0.0; + + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = -g_cur[i]; + g_old[i] = g_cur[i]; + } + } else { // conjugate direction + for (int i = 0; i < 3 * nlocal; i++) { + g2old += g_old[i] * g_old[i]; + g2 += g_cur[i] * g_cur[i]; + } + + // now we need to collect/broadcast beta on this replica + // need to check what is beta for GNEB + + MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); + + // Sum over all replicas. Good for GNEB. + if (update->multireplica == 1) { + g2 = g2_global; + g2old = g2old_global; + MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + if (fabs(g2_global) < 1.0e-60) beta = 0.0; + else beta = g2_global / g2old_global; + // calculate conjugate direction + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = (beta * p_s[i] - g_cur[i]); + g_old[i] = g_cur[i]; + } + } + + local_iter++; +} + +/* ---------------------------------------------------------------------- + rotation of spins along the search direction +---------------------------------------------------------------------- */ + +void MinSpinOSO_CG::advance_spins() +{ + int nlocal = atom->nlocal; + double **sp = atom->sp; + double **fm = atom->fm; + double tdampx, tdampy, tdampz; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + + // loop on all spins on proc. + + for (int i = 0; i < nlocal; i++) { + rodrigues_rotation(p_s + 3 * i, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } +} + +/* ---------------------------------------------------------------------- + compute and return max_i||mag. torque_i||_2 +------------------------------------------------------------------------- */ + +double MinSpinOSO_CG::max_torque() +{ + double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + double factor; + double hbar = force->hplanck/MY_2PI; + + if (use_line_search) factor = 1.0; + else factor = hbar; + + // finding max fm on this proc. + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + fmsq = 0.0; + for (int j = 0; j < 3; j++) + fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + return sqrt(fmaxsqall) * factor; +} + +/* ---------------------------------------------------------------------- + calculate 3x3 matrix exponential using Rodrigues' formula + (R. Murray, Z. Li, and S. Shankar Sastry, + A Mathematical Introduction to + Robotic Manipulation (1994), p. 28 and 30). + + upp_tr - vector x, y, z so that one calculate + U = exp(A) with A= [[0, x, y], + [-x, 0, z], + [-y, -z, 0]] +------------------------------------------------------------------------- */ + +void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) +{ + double theta,A,B,D,x,y,z; + double s1,s2,s3,a1,a2,a3; + + if (fabs(upp_tr[0]) < 1.0e-40 && + fabs(upp_tr[1]) < 1.0e-40 && + fabs(upp_tr[2]) < 1.0e-40){ + + // if upp_tr is zero, return unity matrix + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) + out[3 * k + m] = 1.0; + else + out[3 * k + m] = 0.0; + } + } + return; + } + + theta = sqrt(upp_tr[0] * upp_tr[0] + + upp_tr[1] * upp_tr[1] + + upp_tr[2] * upp_tr[2]); + + A = cos(theta); + B = sin(theta); + D = 1 - A; + x = upp_tr[0]/theta; + y = upp_tr[1]/theta; + z = upp_tr[2]/theta; + + // diagonal elements of U + + out[0] = A + z * z * D; + out[4] = A + y * y * D; + out[8] = A + x * x * D; + + // off diagonal of U + + s1 = -y * z *D; + s2 = x * z * D; + s3 = -x * y * D; + + a1 = x * B; + a2 = y * B; + a3 = z * B; + + out[1] = s1 + a1; + out[3] = s1 - a1; + out[2] = s2 + a2; + out[6] = s2 - a2; + out[5] = s3 + a3; + out[7] = s3 - a3; + +} + +/* ---------------------------------------------------------------------- + out = vector^T x m, + m -- 3x3 matrix , v -- 3-d vector +------------------------------------------------------------------------- */ + +void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) +{ + for(int i = 0; i < 3; i++){ + out[i] *= 0.0; + for(int j = 0; j < 3; j++) + out[i] += *(m + 3 * j + i) * v[j]; + } +} + + +void MinSpinOSO_CG::make_step(double c, double *energy_and_der) +{ + double p_scaled[3]; + int nlocal = atom->nlocal; + double rot_mat[9]; // exponential of matrix made of search direction + double s_new[3]; + double **sp = atom->sp; + double der_e_cur_tmp = 0.0;; + + for (int i = 0; i < nlocal; i++) { + + // scale the search direction + + for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; + + // calculate rotation matrix + + rodrigues_rotation(p_scaled, rot_mat); + + // rotate spins + + vm3(rot_mat, sp[i], s_new); + for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; + } + + ecurrent = energy_force(0); + calc_gradient(); + neval++; + der_e_cur = 0.0; + for (int i = 0; i < 3 * nlocal; i++) { + der_e_cur += g_cur[i] * p_s[i]; + } + MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); + der_e_cur = der_e_cur_tmp; + if (update->multireplica == 1) { + MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); + } + + energy_and_der[0] = ecurrent; + energy_and_der[1] = der_e_cur; +} + +/* ---------------------------------------------------------------------- + Calculate step length which satisfies approximate Wolfe conditions + using the cubic interpolation +------------------------------------------------------------------------- */ + +int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) +{ + double e_and_d[2] = {0.0,0.0}; + double alpha,c1,c2,c3; + double **sp = atom->sp; + int nlocal = atom->nlocal; + + make_step(b,e_and_d); + ecurrent = e_and_d[0]; + der_e_cur = e_and_d[1]; + index++; + + if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 10){ + MPI_Bcast(&b,1,MPI_DOUBLE,0,world); + for (int i = 0; i < 3 * nlocal; i++) { + p_s[i] = b * p_s[i]; + } + return 1; + } + else{ + double r,f0,f1,df0,df1; + r = b - a; + f0 = eprevious; + f1 = ecurrent; + df0 = der_e_pr; + df1 = der_e_cur; + + c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); + c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); + c3 = df0; + + // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 + // has minimum at alpha below. We do not check boundaries. + + alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); + MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); + + if (alpha < 0.0) alpha = r/2.0; + + for (int i = 0; i < nlocal; i++) { + for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; + } + calc_and_make_step(0.0, alpha, index); + } + + return 0; +} + +/* ---------------------------------------------------------------------- + Approximate Wolfe conditions: + William W. Hager and Hongchao Zhang + SIAM J. optim., 16(1), 170-192. (23 pages) +------------------------------------------------------------------------- */ + +int MinSpinOSO_CG::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ + + double eps = 1.0e-6; + double delta = 0.1; + double sigma = 0.9; + + if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + return 1; + else + return 0; +} + /* ---------------------------------------------------------------------- evaluate max timestep ---------------------------------------------------------------------- */ @@ -282,231 +675,4 @@ double MinSpinOSO_CG::evaluate_dt() dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); return dtmax; -} - -/* ---------------------------------------------------------------------- - calculate gradients ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG::calc_gradient(double dts) -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - - // calc. damping torque - - tdampx = -alpha_damp*(fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - tdampy = -alpha_damp*(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tdampz = -alpha_damp*(fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - // calculate gradients - - g_cur[3 * i + 0] = -tdampz * dts; - g_cur[3 * i + 1] = tdampy * dts; - g_cur[3 * i + 2] = -tdampx * dts; - } -} - -/* ---------------------------------------------------------------------- - search direction: - The Fletcher-Reeves conj. grad. method - See Jorge Nocedal and Stephen J. Wright 'Numerical - Optimization' Second Edition, 2006 (p. 121) ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG::calc_search_direction() -{ - int nlocal = atom->nlocal; - double g2old = 0.0; - double g2 = 0.0; - double beta = 0.0; - - double g2_global = 0.0; - double g2old_global = 0.0; - if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i]; - g_old[i] = g_cur[i]; - } - } else { // conjugate direction - for (int i = 0; i < 3 * nlocal; i++) { - g2old += g_old[i] * g_old[i]; - g2 += g_cur[i] * g_cur[i]; - } - - // now we need to collect/broadcast beta on this replica - // different replica can have different beta for now. - // need to check what is beta for GNEB - - MPI_Allreduce(&g2, &g2_global, 1, MPI_DOUBLE, MPI_SUM, world); - MPI_Allreduce(&g2old, &g2old_global, 1, MPI_DOUBLE, MPI_SUM, world); - - // Sum over all replicas. Good for GNEB. - if (update->multireplica == 1) { - g2 = g2_global; - g2old = g2old_global; - MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - if (fabs(g2_global) < 1.0e-60) beta = 0.0; - else beta = g2_global / g2old_global; - // calculate conjugate direction - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = beta * p_s[i] - g_cur[i]; - g_old[i] = g_cur[i]; - } - } - - local_iter++; -} - -/* ---------------------------------------------------------------------- - rotation of spins along the search direction ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG::advance_spins() -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p_s + 3 * i, rot_mat); - - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } -} - -/* ---------------------------------------------------------------------- - compute and return max_i||mag. torque_i||_2 -------------------------------------------------------------------------- */ - -double MinSpinOSO_CG::max_torque() -{ - double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double hbar = force->hplanck/MY_2PI; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = 0.0; - for (int j = 0; j < 3; j++) - fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - return sqrt(fmaxsqall) * hbar; -} - -/* ---------------------------------------------------------------------- - calculate 3x3 matrix exponential using Rodrigues' formula - (R. Murray, Z. Li, and S. Shankar Sastry, - A Mathematical Introduction to - Robotic Manipulation (1994), p. 28 and 30). - - upp_tr - vector x, y, z so that one calculate - U = exp(A) with A= [[0, x, y], - [-x, 0, z], - [-y, -z, 0]] -------------------------------------------------------------------------- */ - -void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) -{ - double theta,A,B,D,x,y,z; - double s1,s2,s3,a1,a2,a3; - - if (fabs(upp_tr[0]) < 1.0e-40 && - fabs(upp_tr[1]) < 1.0e-40 && - fabs(upp_tr[2]) < 1.0e-40){ - - // if upp_tr is zero, return unity matrix - for(int k = 0; k < 3; k++){ - for(int m = 0; m < 3; m++){ - if (m == k) out[3 * k + m] = 1.0; - else out[3 * k + m] = 0.0; - } - } - return; - } - - theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); - - A = cos(theta); - B = sin(theta); - D = 1 - A; - x = upp_tr[0]/theta; - y = upp_tr[1]/theta; - z = upp_tr[2]/theta; - - // diagonal elements of U - - out[0] = A + z * z * D; - out[4] = A + y * y * D; - out[8] = A + x * x * D; - - // off diagonal of U - - s1 = -y * z *D; - s2 = x * z * D; - s3 = -x * y * D; - - a1 = x * B; - a2 = y * B; - a3 = z * B; - - out[1] = s1 + a1; - out[3] = s1 - a1; - out[2] = s2 + a2; - out[6] = s2 - a2; - out[5] = s3 + a3; - out[7] = s3 - a3; - -} - -/* ---------------------------------------------------------------------- - out = vector^T x m, - m -- 3x3 matrix , v -- 3-d vector -------------------------------------------------------------------------- */ - -void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) -{ - for(int i = 0; i < 3; i++){ - out[i] *= 0.0; - for(int j = 0; j < 3; j++){ - out[i] += *(m + 3 * j + i) * v[j]; - } - } -} +} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index 81bbd2c294..e50d1a69db 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -24,7 +24,7 @@ MinimizeStyle(spin/oso_cg, MinSpinOSO_CG) namespace LAMMPS_NS { -class MinSpinOSO_CG : public Min { +class MinSpinOSO_CG: public Min { public: MinSpinOSO_CG(class LAMMPS *); virtual ~MinSpinOSO_CG(); @@ -33,33 +33,34 @@ class MinSpinOSO_CG : public Min { int modify_param(int, char **); void reset_vectors(); int iterate(int); - private: - double evaluate_dt(); - void advance_spins(); - double max_torque(); - void calc_gradient(double); - void calc_search_direction(); - - // global and spin timesteps - - double dt; - double dts; - int nlocal_max; // max value of nlocal (for size of lists) - - double alpha_damp; // damping for spin minimization - double discrete_factor; // factor for spin timestep evaluation - + double dt; // global timestep + double dts; // spin timestep + int ireplica,nreplica; // for neb double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector - - double *g_old; // gradient vector at previous iteration - double *g_cur; // current gradient vector + double *g_cur; // current gradient vector + double *g_old; // gradient vector at previous step double *p_s; // search direction vector - int local_iter; // number of times we call search_direction + double **sp_copy; // copy of the spins + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + double discrete_factor; // factor for spin timestep evaluation + double evaluate_dt(); + void advance_spins(); + void calc_gradient(); + void calc_search_direction(); + double maximum_rotation(double *); void vm3(const double *, const double *, double *); void rodrigues_rotation(const double *, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + void make_step(double, double *); + double max_torque(); + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + int use_line_search; // use line search or not. bigint last_negative; }; diff --git a/src/SPIN/min_spin_oso_cg2.cpp b/src/SPIN/min_spin_oso_cg2.cpp deleted file mode 100644 index 52b98eead7..0000000000 --- a/src/SPIN/min_spin_oso_cg2.cpp +++ /dev/null @@ -1,679 +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 authors: Aleksei Ivanov (University of Iceland) - Julien Tranchida (SNL) - - Please cite the related publication: - Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust - Algorithm for the Minimisation of the Energy of Spin Systems. arXiv - preprint arXiv:1904.02669. -------------------------------------------------------------------------- */ - -#include -#include -#include -#include -#include "min_spin_oso_cg2.h" -#include "universe.h" -#include "atom.h" -#include "citeme.h" -#include "force.h" -#include "update.h" -#include "output.h" -#include "timer.h" -#include "error.h" -#include "memory.h" -#include "modify.h" -#include "math_special.h" -#include "math_const.h" -#include "universe.h" -#include - -using namespace LAMMPS_NS; -using namespace MathConst; - -static const char cite_minstyle_spin_oso_cg2[] = - "min_style spin/oso_cg2 command:\n\n" - "@article{ivanov2019fast,\n" - "title={Fast and Robust Algorithm for the Minimisation of the Energy of " - "Spin Systems},\n" - "author={Ivanov, A. V and Uzdin, V. M. and J{\'o}nsson, H.},\n" - "journal={arXiv preprint arXiv:1904.02669},\n" - "year={2019}\n" - "}\n\n"; - -// EPS_ENERGY = minimum normalization for energy tolerance - -#define EPS_ENERGY 1.0e-8 - -#define DELAYSTEP 5 - - -/* ---------------------------------------------------------------------- */ - -MinSpinOSO_CG2::MinSpinOSO_CG2(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL) -{ - if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg2); - nlocal_max = 0; - - // nreplica = number of partitions - // ireplica = which world I am in universe - - nreplica = universe->nworlds; - ireplica = universe->iworld; - use_line_search = 1; - discrete_factor = 10.0; - -} - -/* ---------------------------------------------------------------------- */ - -MinSpinOSO_CG2::~MinSpinOSO_CG2() -{ - memory->destroy(g_old); - memory->destroy(g_cur); - memory->destroy(p_s); - if (use_line_search) - memory->destroy(sp_copy); -} - -/* ---------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::init() -{ - local_iter = 0; - der_e_cur = 0.0; - der_e_pr = 0.0; - - Min::init(); - - dts = dt = update->dt; - last_negative = update->ntimestep; - - // allocate tables - - nlocal_max = atom->nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg2:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg2:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg2:p_s"); - if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg2:sp_copy"); -} - -/* ---------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::setup_style() -{ - double **v = atom->v; - int nlocal = atom->nlocal; - - // check if the atom/spin style is defined - - if (!atom->sp_flag) - error->all(FLERR,"min/spin_oso_cg2 requires atom/spin style"); - - for (int i = 0; i < nlocal; i++) - v[i][0] = v[i][1] = v[i][2] = 0.0; -} - -/* ---------------------------------------------------------------------- */ - -int MinSpinOSO_CG2::modify_param(int narg, char **arg) -{ - - if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - use_line_search = force->numeric(FLERR,arg[1]); - return 2; - } - if (strcmp(arg[0],"discrete_factor") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); - discrete_factor = force->numeric(FLERR,arg[1]); - return 2; - } - return 0; -} - -/* ---------------------------------------------------------------------- - set current vector lengths and pointers - called after atoms have migrated -------------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::reset_vectors() -{ - // atomic dof - - // size sp is 4N vector - nvec = 4 * atom->nlocal; - if (nvec) spvec = atom->sp[0]; - - nvec = 3 * atom->nlocal; - if (nvec) fmvec = atom->fm[0]; - - if (nvec) xvec = atom->x[0]; - if (nvec) fvec = atom->f[0]; -} - -/* ---------------------------------------------------------------------- - minimization via orthogonal spin optimisation -------------------------------------------------------------------------- */ - -int MinSpinOSO_CG2::iterate(int maxiter) -{ - int nlocal = atom->nlocal; - bigint ntimestep; - double fmdotfm; - int flag, flagall; - double **sp = atom->sp; - double der_e_cur_tmp = 0.0; - - if (nlocal_max < nlocal) { - nlocal_max = nlocal; - local_iter = 0; - nlocal_max = nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg2:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg2:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg2:p_s"); - if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg2:sp_copy"); - } - - for (int iter = 0; iter < maxiter; iter++) { - - if (timer->check_timeout(niter)) - return TIMEOUT; - - ntimestep = ++update->ntimestep; - niter++; - - // optimize timestep accross processes / replicas - // need a force calculation for timestep optimization - - if (use_line_search) { - - // here we need to do line search - if (local_iter == 0) - calc_gradient(); - - calc_search_direction(); - der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) - der_e_cur += g_cur[i] * p_s[i]; - MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); - der_e_cur = der_e_cur_tmp; - if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - for (int i = 0; i < nlocal; i++) - for (int j = 0; j < 3; j++) - sp_copy[i][j] = sp[i][j]; - - eprevious = ecurrent; - der_e_pr = der_e_cur; - calc_and_make_step(0.0, 1.0, 0); - } - else{ - - // here we don't do line search - // but use cutoff rotation angle - // if gneb calc., nreplica > 1 - // then calculate gradients and advance spins - // of intermediate replicas only - - if (nreplica > 1) { - if(ireplica != 0 && ireplica != nreplica-1) - calc_gradient(); - calc_search_direction(); - advance_spins(); - } else{ - calc_gradient(); - calc_search_direction(); - advance_spins(); - } - eprevious = ecurrent; - ecurrent = energy_force(0); - neval++; - } - - //// energy tolerance criterion - //// only check after DELAYSTEP elapsed since velocties reset to 0 - //// sync across replicas if running multi-replica minimization - - if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { - if (update->multireplica == 0) { - if (fabs(ecurrent-eprevious) < - update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) - return ETOL; - } else { - if (fabs(ecurrent-eprevious) < - update->etol * 0.5*(fabs(ecurrent) + fabs(eprevious) + EPS_ENERGY)) - flag = 0; - else flag = 1; - MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); - if (flagall == 0) return ETOL; - } - } - - // magnetic torque tolerance criterion - // sync across replicas if running multi-replica minimization - - if (update->ftol > 0.0) { - fmdotfm = max_torque(); - if (update->multireplica == 0) { - if (fmdotfm < update->ftol*update->ftol) return FTOL; - } else { - if (fmdotfm < update->ftol*update->ftol) flag = 0; - else flag = 1; - MPI_Allreduce(&flag,&flagall,1,MPI_INT,MPI_SUM,universe->uworld); - if (flagall == 0) return FTOL; - } - } - - // output for thermo, dump, restart files - - if (output->next == ntimestep) { - timer->stamp(); - output->write(ntimestep); - timer->stamp(Timer::OUTPUT); - } - } - - return MAXITER; -} - -/* ---------------------------------------------------------------------- - calculate gradients ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::calc_gradient() -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double hbar = force->hplanck/MY_2PI; - double factor; - - if (use_line_search) - factor = hbar; - else factor = evaluate_dt(); - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - g_cur[3 * i + 0] = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]) * factor; - g_cur[3 * i + 1] = -(fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]) * factor; - g_cur[3 * i + 2] = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]) * factor; - } -} - -/* ---------------------------------------------------------------------- - search direction: - The Fletcher-Reeves conj. grad. method - See Jorge Nocedal and Stephen J. Wright 'Numerical - Optimization' Second Edition, 2006 (p. 121) ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::calc_search_direction() -{ - int nlocal = atom->nlocal; - double g2old = 0.0; - double g2 = 0.0; - double beta = 0.0; - - double g2_global = 0.0; - double g2old_global = 0.0; - - if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i]; - g_old[i] = g_cur[i]; - } - } else { // conjugate direction - for (int i = 0; i < 3 * nlocal; i++) { - g2old += g_old[i] * g_old[i]; - g2 += g_cur[i] * g_cur[i]; - } - - // now we need to collect/broadcast beta on this replica - // need to check what is beta for GNEB - - MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,world); - MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); - - // Sum over all replicas. Good for GNEB. - if (update->multireplica == 1) { - g2 = g2_global; - g2old = g2old_global; - MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - if (fabs(g2_global) < 1.0e-60) beta = 0.0; - else beta = g2_global / g2old_global; - // calculate conjugate direction - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = (beta * p_s[i] - g_cur[i]); - g_old[i] = g_cur[i]; - } - } - - local_iter++; -} - -/* ---------------------------------------------------------------------- - rotation of spins along the search direction ----------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::advance_spins() -{ - int nlocal = atom->nlocal; - double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - - // loop on all spins on proc. - - for (int i = 0; i < nlocal; i++) { - rodrigues_rotation(p_s + 3 * i, rot_mat); - - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } -} - -/* ---------------------------------------------------------------------- - compute and return max_i||mag. torque_i||_2 -------------------------------------------------------------------------- */ - -double MinSpinOSO_CG2::max_torque() -{ - double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double factor; - double hbar = force->hplanck/MY_2PI; - - if (use_line_search) factor = 1.0; - else factor = hbar; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = 0.0; - for (int j = 0; j < 3; j++) - fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - return sqrt(fmaxsqall) * factor; -} - -/* ---------------------------------------------------------------------- - calculate 3x3 matrix exponential using Rodrigues' formula - (R. Murray, Z. Li, and S. Shankar Sastry, - A Mathematical Introduction to - Robotic Manipulation (1994), p. 28 and 30). - - upp_tr - vector x, y, z so that one calculate - U = exp(A) with A= [[0, x, y], - [-x, 0, z], - [-y, -z, 0]] -------------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::rodrigues_rotation(const double *upp_tr, double *out) -{ - double theta,A,B,D,x,y,z; - double s1,s2,s3,a1,a2,a3; - - if (fabs(upp_tr[0]) < 1.0e-40 && - fabs(upp_tr[1]) < 1.0e-40 && - fabs(upp_tr[2]) < 1.0e-40){ - - // if upp_tr is zero, return unity matrix - for(int k = 0; k < 3; k++){ - for(int m = 0; m < 3; m++){ - if (m == k) out[3 * k + m] = 1.0; - else out[3 * k + m] = 0.0; - } - } - return; - } - - theta = sqrt(upp_tr[0] * upp_tr[0] + - upp_tr[1] * upp_tr[1] + - upp_tr[2] * upp_tr[2]); - - A = cos(theta); - B = sin(theta); - D = 1 - A; - x = upp_tr[0]/theta; - y = upp_tr[1]/theta; - z = upp_tr[2]/theta; - - // diagonal elements of U - - out[0] = A + z * z * D; - out[4] = A + y * y * D; - out[8] = A + x * x * D; - - // off diagonal of U - - s1 = -y * z *D; - s2 = x * z * D; - s3 = -x * y * D; - - a1 = x * B; - a2 = y * B; - a3 = z * B; - - out[1] = s1 + a1; - out[3] = s1 - a1; - out[2] = s2 + a2; - out[6] = s2 - a2; - out[5] = s3 + a3; - out[7] = s3 - a3; - -} - -/* ---------------------------------------------------------------------- - out = vector^T x m, - m -- 3x3 matrix , v -- 3-d vector -------------------------------------------------------------------------- */ - -void MinSpinOSO_CG2::vm3(const double *m, const double *v, double *out) -{ - for(int i = 0; i < 3; i++){ - out[i] *= 0.0; - for(int j = 0; j < 3; j++) - out[i] += *(m + 3 * j + i) * v[j]; - } -} - - -void MinSpinOSO_CG2::make_step(double c, double *energy_and_der) -{ - double p_scaled[3]; - int nlocal = atom->nlocal; - double rot_mat[9]; // exponential of matrix made of search direction - double s_new[3]; - double **sp = atom->sp; - double der_e_cur_tmp = 0.0;; - - for (int i = 0; i < nlocal; i++) { - - // scale the search direction - - for (int j = 0; j < 3; j++) p_scaled[j] = c * p_s[3 * i + j]; - - // calculate rotation matrix - - rodrigues_rotation(p_scaled, rot_mat); - - // rotate spins - - vm3(rot_mat, sp[i], s_new); - for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; - } - - ecurrent = energy_force(0); - calc_gradient(); - neval++; - der_e_cur = 0.0; - for (int i = 0; i < 3 * nlocal; i++) { - der_e_cur += g_cur[i] * p_s[i]; - } - MPI_Allreduce(&der_e_cur,&der_e_cur_tmp,1,MPI_DOUBLE,MPI_SUM,world); - der_e_cur = der_e_cur_tmp; - if (update->multireplica == 1) { - MPI_Allreduce(&der_e_cur_tmp,&der_e_cur,1,MPI_DOUBLE,MPI_SUM,universe->uworld); - } - - energy_and_der[0] = ecurrent; - energy_and_der[1] = der_e_cur; -} - -/* ---------------------------------------------------------------------- - Calculate step length which satisfies approximate Wolfe conditions - using the cubic interpolation -------------------------------------------------------------------------- */ - -int MinSpinOSO_CG2::calc_and_make_step(double a, double b, int index) -{ - double e_and_d[2] = {0.0,0.0}; - double alpha,c1,c2,c3; - double **sp = atom->sp; - int nlocal = atom->nlocal; - - make_step(b,e_and_d); - ecurrent = e_and_d[0]; - der_e_cur = e_and_d[1]; - index++; - - if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 10){ - MPI_Bcast(&b,1,MPI_DOUBLE,0,world); - for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = b * p_s[i]; - } - return 1; - } - else{ - double r,f0,f1,df0,df1; - r = b - a; - f0 = eprevious; - f1 = ecurrent; - df0 = der_e_pr; - df1 = der_e_cur; - - c1 = -2.0*(f1-f0)/(r*r*r)+(df1+df0)/(r*r); - c2 = 3.0*(f1-f0)/(r*r)-(df1+2.0*df0)/(r); - c3 = df0; - - // f(x) = c1 x^3 + c2 x^2 + c3 x^1 + c4 - // has minimum at alpha below. We do not check boundaries. - - alpha = (-c2 + sqrt(c2*c2 - 3.0*c1*c3))/(3.0*c1); - MPI_Bcast(&alpha,1,MPI_DOUBLE,0,world); - - if (alpha < 0.0) alpha = r/2.0; - - for (int i = 0; i < nlocal; i++) { - for (int j = 0; j < 3; j++) sp[i][j] = sp_copy[i][j]; - } - calc_and_make_step(0.0, alpha, index); - } - - return 0; -} - -/* ---------------------------------------------------------------------- - Approximate Wolfe conditions: - William W. Hager and Hongchao Zhang - SIAM J. optim., 16(1), 170-192. (23 pages) -------------------------------------------------------------------------- */ - -int MinSpinOSO_CG2::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ - - double eps = 1.0e-6; - double delta = 0.1; - double sigma = 0.9; - - if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) - return 1; - else - return 0; -} - -/* ---------------------------------------------------------------------- - evaluate max timestep ----------------------------------------------------------------------- */ - -double MinSpinOSO_CG2::evaluate_dt() -{ - double dtmax; - double fmsq; - double fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double **fm = atom->fm; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = fm[i][0]*fm[i][0]+fm[i][1]*fm[i][1]+fm[i][2]*fm[i][2]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - if (fmaxsqall == 0.0) - error->all(FLERR,"Incorrect fmaxsqall calculation"); - - // define max timestep by dividing by the - // inverse of max frequency by discrete_factor - - dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); - - return dtmax; -} \ No newline at end of file diff --git a/src/SPIN/min_spin_oso_cg2.h b/src/SPIN/min_spin_oso_cg2.h deleted file mode 100644 index 83605f98ed..0000000000 --- a/src/SPIN/min_spin_oso_cg2.h +++ /dev/null @@ -1,72 +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 MINIMIZE_CLASS - -MinimizeStyle(spin/oso_cg2, MinSpinOSO_CG2) - -#else - -#ifndef LMP_MIN_SPIN_OSO_CG2_H -#define LMP_MIN_SPIN_OSO_CG2_H - -#include "min.h" - -namespace LAMMPS_NS { - -class MinSpinOSO_CG2: public Min { - public: - MinSpinOSO_CG2(class LAMMPS *); - virtual ~MinSpinOSO_CG2(); - void init(); - void setup_style(); - int modify_param(int, char **); - void reset_vectors(); - int iterate(int); - private: - double dt; // global timestep - double dts; // spin timestep - int ireplica,nreplica; // for neb - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_cur; // current gradient vector - double *g_old; // gradient vector at previous step - double *p_s; // search direction vector - double **sp_copy; // copy of the spins - int local_iter; // for neb - int nlocal_max; // max value of nlocal (for size of lists) - double discrete_factor; // factor for spin timestep evaluation - - double evaluate_dt(); - void advance_spins(); - void calc_gradient(); - void calc_search_direction(); - double maximum_rotation(double *); - void vm3(const double *, const double *, double *); - void rodrigues_rotation(const double *, double *); - int calc_and_make_step(double, double, int); - int awc(double, double, double, double); - void make_step(double, double *); - double max_torque(); - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - int use_line_search; // use line search or not. - double maxepsrot; - - bigint last_negative; -}; - -} - -#endif -#endif From 07f2f5e5266983d3fcec42c5e50ac19ce82903f4 Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 18:15:32 +0000 Subject: [PATCH 058/557] no line search for multireplica --- src/SPIN/min_spin_oso_cg.cpp | 10 +++++++++- src/SPIN/min_spin_oso_lbfgs.cpp | 12 ++++++++++-- 2 files changed, 19 insertions(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index c9f3a59f87..21927d0d31 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -73,7 +73,11 @@ MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; - use_line_search = 1; + if (nreplica > 1) + use_line_search = 0; // no line search for NEB + else + use_line_search = 1; + discrete_factor = 10.0; } @@ -134,6 +138,10 @@ int MinSpinOSO_CG::modify_param(int narg, char **arg) if (strcmp(arg[0],"line_search") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); use_line_search = force->numeric(FLERR,arg[1]); + + if (nreplica > 1 && use_line_search) + error->all(FLERR,"Illegal fix_modify command, cannot use NEB and line search together"); + return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index d7e7302e4f..eba62f296f 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -73,7 +73,11 @@ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; - use_line_search = 1; + if (nreplica > 1) + use_line_search = 0; // no line search for NEB + else + use_line_search = 1; + maxepsrot = MY_2PI / (100.0); } @@ -143,13 +147,17 @@ int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) if (strcmp(arg[0],"line_search") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); use_line_search = force->numeric(FLERR,arg[1]); + + if (nreplica > 1 && use_line_search) + error->all(FLERR,"Illegal fix_modify command, cannot use NEB and line search together"); + return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); double discrete_factor; discrete_factor = force->numeric(FLERR,arg[1]); - maxepsrot = MY_2PI / discrete_factor; + maxepsrot = MY_2PI / (10 * discrete_factor); return 2; } return 0; From 89bfe4acf23eb09e6c9ab04302fb1faef89106de Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 18:29:24 +0000 Subject: [PATCH 059/557] change convergence criteria in min_spin --- src/SPIN/min_spin.cpp | 42 +++++++++++++++++++++++++++++++++++++++++- src/SPIN/min_spin.h | 1 + 2 files changed, 42 insertions(+), 1 deletion(-) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 2277281e80..9849ba9946 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -167,7 +167,7 @@ int MinSpin::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fmdotfm = fmnorm_sqr(); + fmdotfm = max_torque(); if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -331,3 +331,43 @@ double MinSpin::fmnorm_sqr() return norm2_sqr; } +/* ---------------------------------------------------------------------- + compute and return max_i||mag. torque_i||_2 +------------------------------------------------------------------------- */ + +double MinSpin::max_torque() +{ + double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; + int nlocal = atom->nlocal; + double hbar = force->hplanck/MY_2PI; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = fm[i][1] * sp[i][2] - fm[i][2] * sp[i][1]; + ty = fm[i][2] * sp[i][0] - fm[i][0] * sp[i][2]; + tz = fm[i][0] * sp[i][1] - fm[i][1] * sp[i][0]; + fmsq = tx * tx + ty * ty + tz * tz; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqloc = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); + + // finding max fm over all replicas, if necessary + // this communicator would be invalid for multiprocess replicas + + fmaxsqall = fmaxsqloc; + if (update->multireplica == 1) { + fmaxsqall = fmaxsqloc; + MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); + } + + // multiply it by hbar so that units are in eV + + return sqrt(fmaxsqall) * hbar; +} diff --git a/src/SPIN/min_spin.h b/src/SPIN/min_spin.h index fbc624a9cc..d6d49203d5 100644 --- a/src/SPIN/min_spin.h +++ b/src/SPIN/min_spin.h @@ -36,6 +36,7 @@ class MinSpin : public Min { double evaluate_dt(); void advance_spins(double); double fmnorm_sqr(); + double max_torque(); private: From a9a2c7a496b38e4f30f6aa8389e6f7a58e13267c Mon Sep 17 00:00:00 2001 From: alxvov Date: Mon, 22 Jul 2019 18:31:14 +0000 Subject: [PATCH 060/557] no line search as default option for CG --- src/SPIN/min_spin_oso_cg.cpp | 5 +---- 1 file changed, 1 insertion(+), 4 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 21927d0d31..843f1e48f1 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -73,10 +73,7 @@ MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; - if (nreplica > 1) - use_line_search = 0; // no line search for NEB - else - use_line_search = 1; + use_line_search = 0; // no line search as default option for CG discrete_factor = 10.0; } From 1f4039048936835fb84a1e7a0f21d920b28a14ab Mon Sep 17 00:00:00 2001 From: casievers Date: Mon, 22 Jul 2019 13:48:02 -0700 Subject: [PATCH 061/557] recent change to gjf tally (not working) --- examples/gjf/out.argon | 249 ---------------------------------- examples/gjf/trajectory.0.dcd | Bin 439092 -> 0 bytes src/fix_langevin.cpp | 7 +- 3 files changed, 6 insertions(+), 250 deletions(-) delete mode 100644 examples/gjf/out.argon delete mode 100644 examples/gjf/trajectory.0.dcd diff --git a/examples/gjf/out.argon b/examples/gjf/out.argon deleted file mode 100644 index 8dda569157..0000000000 --- a/examples/gjf/out.argon +++ /dev/null @@ -1,249 +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 -Reading data file ... - orthogonal box = (0 0 0) to (32.146 32.146 32.146) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 864 atoms -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -Setting up the ensembles -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -Doing Molecular dynamics -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.94072 - ghost atom cutoff = 6.94072 - binsize = 3.47036, bins = 10 10 10 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cubic, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d/newton - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.12 -Per MPI rank memory allocation (min/avg/max) = 6.847 | 6.847 | 6.847 Mbytes -Time Temp PotEng TotEng Press Volume CPU - 0 10 -56.207655 -55.09214 33.340921 33218.561 0 - 24 10.156356 -55.092888 -53.959932 339.40964 33218.561 0.082175482 - 48 9.6121006 -55.07262 -54.000376 344.56765 33218.561 0.19529325 - 72 9.8187467 -55.16687 -54.071574 318.85979 33218.561 0.29643488 - 96 9.5421385 -55.151229 -54.086789 322.8842 33218.561 0.38801357 - 120 10.295035 -55.12919 -53.980763 332.00171 33218.561 0.47607262 - 144 10.331608 -55.09907 -53.946563 339.28896 33218.561 0.57389224 - 168 10.154698 -55.058246 -53.925475 349.03253 33218.561 0.65481471 - 192 9.858198 -55.127583 -54.027886 330.09298 33218.561 0.74437734 - 216 9.6658918 -55.10812 -54.029875 334.28383 33218.561 0.8278495 - 240 9.6801591 -55.102386 -54.02255 336.27242 33218.561 0.91167379 - 264 10.685658 -55.046238 -53.854237 355.0448 33218.561 1.0023789 - 288 10.387727 -55.08427 -53.925504 343.87247 33218.561 1.0960371 - 312 10.231132 -55.120428 -53.97913 333.22463 33218.561 1.2382998 - 336 10.20896 -55.075142 -53.936317 344.88438 33218.561 1.3420489 - 360 9.7876538 -55.165008 -54.07318 319.14962 33218.561 1.42782 - 384 9.9872551 -55.13881 -54.024717 327.82471 33218.561 1.5417666 - 408 9.5362734 -55.063733 -53.999947 346.50545 33218.561 1.6328366 - 432 10.262638 -55.126608 -53.981796 332.16342 33218.561 1.7242996 - 456 9.9228239 -55.122119 -54.015214 332.26261 33218.561 1.8124888 - 480 9.7026324 -55.17057 -54.088227 317.84818 33218.561 1.900233 - 504 10.028762 -55.082465 -53.963741 343.04257 33218.561 1.989605 - 528 9.8227851 -55.121222 -54.025476 332.42857 33218.561 2.0708802 - 552 10.208672 -55.100242 -53.961449 338.68109 33218.561 2.1527217 - 576 10.180849 -55.124065 -53.988376 331.29516 33218.561 2.238126 - 600 9.6467252 -55.119533 -54.043427 332.43109 33218.561 2.323443 - 624 10.041885 -55.173802 -54.053614 318.48579 33218.561 2.4046151 - 648 10.151597 -55.111725 -53.979299 334.66227 33218.561 2.4902161 - 672 9.7719111 -55.060111 -53.970039 348.55249 33218.561 2.5800372 - 696 10.476688 -55.088109 -53.919419 342.94922 33218.561 2.6731395 - 720 10.517805 -55.113604 -53.940327 335.47342 33218.561 2.760651 - 744 10.006466 -55.045085 -53.928848 353.53813 33218.561 2.8537894 - 768 10.201492 -55.081598 -53.943606 343.3206 33218.561 2.9404115 - 792 10.117738 -55.077806 -53.949157 345.31093 33218.561 3.030765 - 816 10.362288 -55.11635 -53.960421 333.9045 33218.561 3.1177356 - 840 10.204164 -55.097619 -53.959329 338.82717 33218.561 3.2091886 - 864 10.147722 -55.101372 -53.969378 338.19682 33218.561 3.3003742 - 888 9.9265037 -55.111394 -54.004077 334.08116 33218.561 3.395341 - 912 10.206403 -55.132181 -53.993642 328.89904 33218.561 3.4882881 - 936 10.28639 -55.093317 -53.945855 340.61244 33218.561 3.5764735 - 960 9.8028822 -55.078802 -53.985276 343.5904 33218.561 3.7056267 - 984 10.492755 -55.121321 -53.950839 334.62697 33218.561 3.8055611 - 1008 10.621569 -55.088588 -53.903736 343.33166 33218.561 3.9144807 - 1032 10.006729 -55.113459 -53.997193 334.43025 33218.561 4.0189888 - 1056 10.099853 -55.068035 -53.941381 347.42158 33218.561 4.1391664 - 1080 10.254232 -55.066685 -53.92281 347.15777 33218.561 4.2443953 - 1104 9.9495142 -55.13686 -54.026977 327.63107 33218.561 4.3368342 - 1128 10.377108 -55.08846 -53.930878 344.13083 33218.561 4.4287748 - 1152 10.036981 -55.114643 -53.995003 334.88053 33218.561 4.526868 - 1176 10.144779 -55.097125 -53.965459 339.698 33218.561 4.6614049 - 1200 10.075844 -55.14695 -54.022974 326.05911 33218.561 4.799835 - 1224 10.183695 -55.121716 -53.98571 332.75772 33218.561 4.8908897 - 1248 10.581369 -55.027954 -53.847587 359.06251 33218.561 4.9839788 - 1272 10.158269 -55.105173 -53.972003 337.52964 33218.561 5.0918646 - 1296 9.8776072 -55.064085 -53.962223 347.15648 33218.561 5.2291209 - 1320 10.38161 -55.118366 -53.960282 335.17767 33218.561 5.3570446 - 1344 9.9528146 -55.141937 -54.031685 326.27117 33218.561 5.4584705 - 1368 9.8024326 -55.117808 -54.024332 332.99835 33218.561 5.5557818 - 1392 10.35447 -55.110235 -53.955179 336.80412 33218.561 5.6467392 - 1416 10.199061 -55.105641 -53.96792 337.36785 33218.561 5.7476527 - 1440 9.6868779 -55.087316 -54.00673 340.9166 33218.561 5.8432207 - 1464 10.093238 -55.049436 -53.92352 352.27563 33218.561 5.9471521 - 1488 9.7578808 -55.123935 -54.035429 329.93926 33218.561 6.0495014 - 1512 10.099979 -55.205426 -54.078758 309.26166 33218.561 6.1612976 - 1536 10.172944 -55.087106 -53.952299 342.93395 33218.561 6.2506202 - 1560 10.51771 -55.107635 -53.934369 340.1967 33218.561 6.3379856 - 1584 10.044994 -55.101362 -53.980828 339.03163 33218.561 6.4362567 - 1608 9.624758 -55.146246 -54.07259 324.32486 33218.561 6.5385845 - 1632 9.9135215 -55.097278 -53.99141 338.69162 33218.561 6.6452786 - 1656 9.863681 -55.070523 -53.970214 345.84608 33218.561 6.7518212 - 1680 10.138513 -55.127065 -53.996099 330.40757 33218.561 6.8775188 - 1704 10.382237 -55.070572 -53.912417 347.074 33218.561 7.0126448 - 1728 10.72487 -55.081147 -53.884771 345.83623 33218.561 7.1384216 - 1752 9.829431 -55.131041 -54.034553 328.57652 33218.561 7.2616419 - 1776 9.9135662 -55.100556 -53.994682 336.52238 33218.561 7.4193201 - 1800 10.41873 -55.097116 -53.934891 340.24798 33218.561 7.5570544 - 1824 10.151782 -55.03231 -53.899864 357.3654 33218.561 7.6872905 - 1848 10.42307 -55.043808 -53.881099 355.71677 33218.561 7.7933885 - 1872 10.276862 -55.085016 -53.938616 344.46273 33218.561 7.8887472 - 1896 9.7681373 -55.146507 -54.056857 324.84323 33218.561 7.9977923 - 1920 9.6624824 -55.103214 -54.025349 336.06397 33218.561 8.090235 - 1944 10.153504 -55.049175 -53.916536 352.36339 33218.561 8.1923703 - 1968 10.191954 -55.098741 -53.961813 338.8667 33218.561 8.3320906 - 1992 9.92167 -55.117079 -54.010302 332.96497 33218.561 8.4774437 - 2016 9.5737281 -55.091141 -54.023178 339.41837 33218.561 8.6149527 - 2040 10.600908 -55.092717 -53.91017 342.71852 33218.561 8.7639523 - 2064 9.9214513 -55.099904 -53.993151 337.46799 33218.561 8.898087 - 2088 9.9256258 -55.082224 -53.975005 342.85042 33218.561 9.0130784 - 2112 10.345379 -55.112923 -53.95888 335.81471 33218.561 9.1422766 - 2136 9.8876649 -55.079254 -53.97627 343.05764 33218.561 9.2885707 - 2160 10.04492 -55.074876 -53.95435 344.82419 33218.561 9.3876103 - 2184 10.028705 -55.063961 -53.945244 347.70549 33218.561 9.500967 - 2208 10.412572 -55.136316 -53.974778 329.8188 33218.561 9.5900362 - 2232 10.404205 -55.09913 -53.938525 339.77542 33218.561 9.7048353 - 2256 9.5694135 -55.139021 -54.071538 326.37473 33218.561 9.8045958 - 2280 10.244745 -55.134529 -53.991713 329.19392 33218.561 9.8968908 - 2304 9.9129922 -55.116192 -54.010382 333.14326 33218.561 9.9818651 - 2328 10.167027 -55.08241 -53.948263 343.08135 33218.561 10.068683 - 2352 10.262045 -55.144327 -53.999581 327.40876 33218.561 10.155937 - 2376 10.520934 -55.073147 -53.899521 347.6998 33218.561 10.246316 - 2400 9.9628692 -55.122001 -54.010628 331.25369 33218.561 10.336833 - 2424 10.565531 -55.157113 -53.978512 325.14897 33218.561 10.452039 - 2448 10.03709 -55.096409 -53.976756 338.29607 33218.561 10.537936 - 2472 9.384311 -55.141821 -54.094987 324.23247 33218.561 10.628689 - 2496 9.8019362 -55.105685 -54.012264 335.97239 33218.561 10.717287 - 2520 10.31114 -55.078831 -53.928608 345.42395 33218.561 10.818756 - 2544 10.407237 -55.148382 -53.987439 325.94421 33218.561 10.910801 - 2568 10.257967 -55.041348 -53.897056 355.73261 33218.561 11.004221 - 2592 9.8425807 -55.139428 -54.041474 328.28096 33218.561 11.101295 - 2616 10.140697 -55.100238 -53.969028 338.76319 33218.561 11.192211 - 2640 9.7102818 -55.136288 -54.053091 326.7053 33218.561 11.280277 - 2664 10.120372 -55.128779 -53.999836 330.71707 33218.561 11.369001 - 2688 10.232537 -55.120614 -53.979159 333.35087 33218.561 11.464652 - 2712 10.032526 -55.094761 -53.975618 339.97984 33218.561 11.559387 - 2736 9.8791 -55.121998 -54.01997 332.32556 33218.561 11.649679 - 2760 9.891483 -55.120919 -54.017509 331.32614 33218.561 11.742604 - 2784 10.201053 -55.165525 -54.027582 320.39272 33218.561 11.85274 - 2808 10.238648 -55.096449 -53.954312 340.06316 33218.561 11.939782 - 2832 9.8692851 -55.068632 -53.967699 346.77535 33218.561 12.036655 - 2856 10.179976 -55.128413 -53.992822 331.5662 33218.561 12.123227 - 2880 9.7656315 -55.1468 -54.057429 324.02612 33218.561 12.213117 - 2904 9.7991628 -55.049191 -53.95608 352.45738 33218.561 12.326761 - 2928 10.581767 -55.093293 -53.912881 341.37292 33218.561 12.417633 - 2952 10.546144 -55.07452 -53.898081 347.02025 33218.561 12.52701 - 2976 9.8306008 -55.14762 -54.051002 323.45715 33218.561 12.633522 - 3000 10.033532 -55.076433 -53.957178 345.36812 33218.561 12.72627 - 3024 10.046266 -55.085775 -53.965099 342.47786 33218.561 12.816242 - 3048 10.176777 -55.133013 -53.997778 329.04144 33218.561 12.903175 - 3072 9.9778064 -55.143787 -54.030748 326.75284 33218.561 13.014329 - 3096 10.516223 -55.110144 -53.937043 336.802 33218.561 13.104673 - 3120 9.6561157 -55.138699 -54.061544 325.6652 33218.561 13.207371 - 3144 10.237043 -55.060968 -53.91901 349.44011 33218.561 13.303442 - 3168 9.9704264 -55.123073 -54.010857 332.19725 33218.561 13.391877 - 3192 10.493307 -55.144402 -53.973858 327.15485 33218.561 13.482857 - 3216 10.022171 -55.141782 -54.023794 326.08249 33218.561 13.574484 - 3240 9.6957248 -55.137865 -54.056292 326.04858 33218.561 13.671408 - 3264 9.9685299 -55.124301 -54.012297 331.9015 33218.561 13.760186 - 3288 10.413707 -55.153604 -53.99194 324.32939 33218.561 13.877604 - 3312 10.022953 -55.103422 -53.985346 337.52066 33218.561 13.977562 - 3336 10.044478 -55.110297 -53.98982 334.48379 33218.561 14.065563 - 3360 9.8593734 -55.130623 -54.030795 327.71748 33218.561 14.15952 - 3384 9.9269422 -55.107979 -54.000613 335.18173 33218.561 14.258064 - 3408 10.288049 -55.092276 -53.944629 340.71484 33218.561 14.36211 - 3432 9.9702156 -55.08732 -53.975128 341.72171 33218.561 14.452123 - 3456 10.246178 -55.091669 -53.948692 341.62844 33218.561 14.555775 - 3480 10.559292 -55.086917 -53.909012 343.70626 33218.561 14.645718 - 3504 10.652207 -55.050897 -53.862628 354.46979 33218.561 14.797422 - 3528 9.9835266 -55.0557 -53.942023 350.74747 33218.561 14.895716 - 3552 10.240934 -55.123217 -53.980825 332.26434 33218.561 15.023796 - 3576 10.406519 -55.093536 -53.932674 341.54029 33218.561 15.203252 - 3600 10.406733 -55.095168 -53.934282 341.22192 33218.561 15.303986 - 3624 9.9877484 -55.154231 -54.040083 323.55633 33218.561 15.398883 - 3648 10.391829 -55.110208 -53.950984 337.09219 33218.561 15.49042 - 3672 10.368995 -55.069591 -53.912914 346.82649 33218.561 15.582259 - 3696 10.362939 -55.109012 -53.953011 337.32216 33218.561 15.679316 - 3720 10.465254 -55.136214 -53.968799 331.22288 33218.561 15.773303 - 3744 9.8238226 -55.10114 -54.005278 338.12616 33218.561 15.86905 - 3768 10.205504 -55.101263 -53.962824 339.04196 33218.561 15.960072 - 3792 9.9589987 -55.118883 -54.007942 332.84318 33218.561 16.047055 - 3816 10.253382 -55.117513 -53.973732 334.42101 33218.561 16.148412 - 3840 10.262393 -55.069549 -53.924764 349.084 33218.561 16.235391 - 3864 9.7367167 -55.078288 -53.992142 342.48207 33218.561 16.329112 - 3888 10.171202 -55.134701 -54.000088 329.5847 33218.561 16.415353 - 3912 10.01925 -55.145139 -54.027477 326.65074 33218.561 16.526334 - 3936 10.053638 -55.038151 -53.916653 355.74893 33218.561 16.618524 - 3960 10.044055 -55.058382 -53.937953 349.01834 33218.561 16.712577 - 3984 10.382422 -55.099216 -53.941041 339.28099 33218.561 16.79941 - 4008 9.97927 -55.09284 -53.979637 339.07225 33218.561 16.904198 - 4032 9.6782319 -55.126143 -54.046522 329.0201 33218.561 16.991454 - 4056 9.6593809 -55.123677 -54.046159 329.89833 33218.561 17.097172 - 4080 10.442896 -55.141149 -53.976229 327.9899 33218.561 17.189364 - 4104 9.9571109 -55.08588 -53.975149 341.3746 33218.561 17.294147 - 4128 10.44943 -55.087946 -53.922296 343.09435 33218.561 17.387357 - 4152 10.040581 -55.171939 -54.051897 317.85348 33218.561 17.500905 - 4176 10.089442 -55.128713 -54.00322 330.29121 33218.561 17.588891 - 4200 10.316156 -55.123219 -53.972436 333.59382 33218.561 17.679254 - 4224 10.177245 -55.095671 -53.960384 339.34498 33218.561 17.770569 - 4248 9.7129183 -55.135335 -54.051844 328.25125 33218.561 17.857728 - 4272 10.231838 -55.099554 -53.958177 339.64015 33218.561 17.944226 - 4296 9.9737677 -55.117885 -54.005297 333.07248 33218.561 18.034105 - 4320 10.004955 -55.116155 -54.000088 333.52271 33218.561 18.129644 - 4344 9.5938901 -55.133824 -54.063612 327.84171 33218.561 18.215476 - 4368 9.8954562 -55.131603 -54.02775 329.0813 33218.561 18.306539 - 4392 10.439732 -55.100379 -53.935812 339.81679 33218.561 18.395651 - 4416 9.934513 -55.08449 -53.97628 341.74441 33218.561 18.484506 - 4440 10.025998 -55.136771 -54.018356 327.73718 33218.561 18.593946 - 4464 9.9304451 -55.101817 -53.994061 338.1801 33218.561 18.684011 - 4488 10.344371 -55.085856 -53.931926 342.91721 33218.561 18.782399 - 4512 10.033193 -55.091778 -53.972561 339.85728 33218.561 18.879666 - 4536 9.2361614 -55.169375 -54.139067 316.67597 33218.561 18.983667 - 4560 9.5786289 -55.179976 -54.111465 314.76415 33218.561 19.079009 - 4584 10.071651 -55.107218 -53.98371 336.10364 33218.561 19.163975 - 4608 9.9873098 -55.109348 -53.995249 336.03665 33218.561 19.25635 - 4632 10.143888 -55.119423 -53.987857 333.74978 33218.561 19.346658 - 4656 9.7506264 -55.114772 -54.027075 332.98271 33218.561 19.435425 - 4680 9.9616769 -55.096054 -53.984814 339.20499 33218.561 19.55562 - 4704 10.271313 -55.074522 -53.928742 345.87397 33218.561 19.642652 - 4728 9.9172336 -55.098805 -53.992523 338.06318 33218.561 19.734557 - 4752 9.9556222 -55.12128 -54.010716 332.66408 33218.561 19.83859 - 4776 10.197593 -55.095293 -53.957736 339.50067 33218.561 19.947471 - 4800 10.145085 -55.108467 -53.976768 336.05115 33218.561 20.044183 - 4824 10.205523 -55.147376 -54.008934 325.56559 33218.561 20.144393 - 4848 9.8900281 -55.121598 -54.01835 331.17401 33218.561 20.243197 - 4872 10.03655 -55.100936 -53.981343 337.6777 33218.561 20.336043 - 4896 9.8120635 -55.087507 -53.992957 341.42438 33218.561 20.425498 - 4920 10.615354 -55.093335 -53.909176 342.30776 33218.561 20.519318 - 4944 10.374366 -55.06455 -53.907274 351.10607 33218.561 20.612312 - 4968 10.677474 -55.147807 -53.956718 327.85703 33218.561 20.719371 - 4992 10.558882 -55.145253 -53.967393 327.427 33218.561 20.818726 - 5016 9.4097946 -55.150835 -54.101158 321.62641 33218.561 20.914472 diff --git a/examples/gjf/trajectory.0.dcd b/examples/gjf/trajectory.0.dcd deleted file mode 100644 index 47927e9909cfcfc86ceb2568ba1660efed5834f2..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 439092 zcmeEubx>P-)a?m%rApmsu_RbsfbNyL3nZbgw72dqgu2rf66!*Wph-<^4HzCT{SnRe#fz`5b@<0pHsz1G?Z5d@)KufFZ2{QB$P>mq{S zx$A#^`5*ohne`=5@*nR0#~ao8RtR5v`Eue*J$20V>0uM=51&)NJ9_l!9nAOsEC2d- z=z+f7g6p@N8a8Zt*vR_+t?GB3F@BD`u^)dmY(-ooB;CH&xri%ET zuA4oq_?@ow=`!BWzt1%zO2F@Q-Rz;__4<9T8bx*Zovt>IO!%FyvFSGaPS@{rwtkJ} zcRE|Y#_~IztzTpLozB*;vHVVF>(^L*r?d5IEWZyj{Cgz76E^%cmfr~*{u;~ggbja< z<#)n{zsB-AVZ&cz`Bj7cy8bPX{aZfyx48aq@%7*0+`q+}KjZlucm0{4zwz*Y|NZly z^9uhKzyB?c{#!izx406a6%_y3^>2CX&v^cxuRrtiH;?h3?VVrue!uzo&pD1i`Rng` z`AwmAq{^8C3;fH?J0RM1%|8Q9Ua5aDK z|IJzbnTJ2~@aMez&A0!Vhd=Z1|1Tc?%}M{mz5bJf|KY0t-2XE_|L_O@=mr1q;(zY{ ztq=T}hd=Z1CrXpm(Y^Am!1@=C8=JhlmhR%a#ke$om+@u8W5&4T8^#Y` zoijr9a{~siOAZXaC=2*xhzXqXBRk#p$|e0-?qXx>Dl?56{Er64F4+~BwoYq&xMO{w z-?^fJx+UR(`$BvIr>{>Ae7df6z_=CF(^p>$HokaVGH}(bqv>1RPa2~ZA5ZTX*|<%& zw+Y6ge!Bvve|i-7zar8sq2G8`u^Xug3{n85=5-DollSAt##j;B>3>qcJ`&LpsnJ>fDZBm>Llp!UVy_6lL_&8jO zOD*M)?2;kOKLVMEz@2~yTzjR##UdJvpRB=kYmM&@~kE2TVQBvfvnJiz78t}b+cl!s};M{RtS@=2>)(@ z`Mw2Dy72oV`E`i}m#$mk+0KH`v#nU9v|_8t0!MQzKJ3ZH#urvZTP<)sW5v#4R$PB( zL9tH0)X*-cjVpZU&~Z;{V09(0=1s`?jwhA)+K_%u^`^v{Ze$$jP8~+esq;Z8#gF%< zBQCy_(a?*2UTaQaUd^fTTwf|$LQdU}HK6IwdRlm}Z{6D+V z?j16!e_Bpube_~_mIpQN=tdJ}xYGP8a+)#Pk8-mMsdGC4g{=#zl#_t0>xDF`xddwucTlxd2PM~+VEy?} z+`rrpYnS!I&^jSVa8g0nUX8o0RTwc*3F~t;BBrX)y@nD!SB2nuloB=Ph9ES~; zimy>YdQ^q4$3l@cQw>+O3Om;X<3)f9p@k}hPg0@xLN#8VP@;=G1T{;kvAKj2i&m>) z<>&7AP~kxN5EQMa!u*#iOzN-2fnz!}?HL2@LmfsO*J5rj9hxU;vFU&gmlZlRiq_#% z10Cj;(jl?54(9^3i1XFLRU3_%3R)cY(V_8kEo?P)XfacV_K{jVpQA;sfm$q|sfFLK z=QPn_$zd%@6>2f8l@3z=9iQ&$kbF~z{RKLd=o^EeTrG~4FvGFjgarposI}XSEsxDO z^3#L^uT3ztF`?X66TVh4A^cq?R8vi;KGTf1rOjx2)`VkS&4^l(iD&0BK_ktm`6v@b z@0c*Aml*~Z6NC!)2%)O$;_%cw|Gp+IFPP%7JNt4Ks_` z(QByooK_hoE*3{vq9x-$6u4|c-h>JaxpfNBS2qDg4;8GlI@xV z?t=u3kC31QpPNs$1(eS#q$xoH+-?fE(b+*MLLm)XQb?uS7Sh@1-|R09?ItWaV=MS!OR1U$7}H%1q_&wOZuA(ZO|`4xdkG z(e{BBg%$YcqqTUmUk9(TI?R}%#oj?$M4r~-r(O%y2_0fP#UQL=48D5n;9}I`VJbgY zn}y!dCXDN3hIXeJ>lT`Dkk8!K875pYW}?keGae^o;qnPSLoZDb4w+DIxCxWyn31*A zghp}vvzeJZPbTDEG$H%32@9v05MwgIZ?g&G`MjO3YR1*=CKP-#!DW&e&)S-?rg9d} z$;=!}%xF>Bj8wG=8#N}pt6;;vB{mdpx1o7k8>*DEq1*>EYz4n4mf8g9c}y$v@UIS6lJ zgTBy)obfg^`Iv(x={776%99&9|++B?19+AyQa`IfQd)pEw^ zD}MykKD8#`_4(QXVV(m5;&+ZUmP-f=+&k;@iT97+rN3+RDLt()<;2s0D+A-d8v{2M z>ze+odX$`KXH~Lm3ANN+whG@yZKpt7k+G`m$2J-nVs&5P;DxZgmdoDylt z?L=C1Gm&$iNJXyb>GkY1YHv)Y1G;1yo^GJ^u8EYSHBkBaNfdc1nfhJR(|UOlZ7wcS z&>cP9SeHzZIzmbBYBRsETwdCS|O6pnq=y|IGJ*T4HSG? zibFqSc-}{bB3r%SS4#^03ON?+_r@NH96!IxaBiFo@88H!r7Qalo67OIryR@r%iujm z3Xd6HxLrYppsF(1S9!s8ycA_i%3$>OM&qk8ge>wzpIb7_GDzWCSBk@sggRwA}Aeyhd!F0_~dy`M1#93*1!C_NlyL>zv`IFg_B@-Smb zlOEJvMCw`*9W)|JToSRGzdp*iFp-~On9jJ<*MNm<40yIpM5loU^y1&wzm^D9pam|= zEht&aigPovQ6t!jF}tl;UEhLXdACq!niYYSt;j#cSg@xB1DjY;ow20xwiRWZtVmsK z#hxe&&iY!hILv~h@fJ+DVSyk2zc>8e3qP$GcisXF%frYE^WwfcOH&se^&^^XhTSgR+Uke9` z!4ArD7LdZ;@GbAvDCMU{SQ{1IWQV}1w-VWBwWyk=#T1Jc5sWibjkVY|Fb1t_n9-zx z2}X?>@`6k(Ich@Hsb)0bIB*&^)Gn}LK^+_RF6S7K%V*zHN_ZzD*SY>QQ^)!7rZ>Hf zlv0hF1vFw#0X^IzU~E7k>5~N1>mWgtnd5u~HTI2DLH&*M%;gYt@KR&+869Gd=org$ z9M052J6ns`k~%D(WyaL`CS2WQf-J^_E8-4NoNlQWm%zrPz=+zQD@^DaH#;QAg`{B)JC05=J zL1o5~_8w}8ob&4SkKvr8L%E(h%x3JBR8@yl={ls|HsL*wq46LyigTQw*xif^pG+t{ z!HyanV@t2%I2mNaF2*&Ub8Kkz)Qvi~_oU4AGTNQwLt|$7(&|o4=mq27LG2}&A{S83 zPy}=@{<;oCfSR^f|>8mhKxBwN4J)pX4BE zr457L%4qfyciPykDQ#`slsZ3hBUu?A8g7+fd0k$w0Y#7zEWyC@PIx1A;u=r|d6y8p zAFsr)bTx)IQ(^D{HT*e$uRj}&p3gYvkJqAE865_3{x8>>=V!19yRMo*3KLAvP3Uhl z;REB--4An+=4XTAnhom295lPfzWik(-SRY$=4%Qa_fMk0N_uKh#z5{)9D8?oVLr#= z`PJp9+FFY0XQimnm%Z4>G`PMu97A$7_&QjFJ)<;m_7u@=j~-9Y=ppN>hxomMn&WJR+`D_Y8}comq9xZ#4rHbqcWlt~mXCkl$#k`jgI89{NeOcH&+sHfOr zDWpkGpz^y!GOLm({;m{0O}*gJObSS)xYtXD_=9phB>ubLGbs#+oPxV~Ms;L9zpgEv~y?w+6+-$PLJ_$ep` z$R&z1vjxTe6hX18auPMXmq^ZgQz&q3DoyKUpo=f`w7I+tBWKAmH(CZ8&sF?68Agp} zKEx{mpEER=+L-f1)d)oY2*=GG5pYY@BQ-$861@S_jd}z-889#?8PnHVF^OyMvXipm zQXw1F`ekEG2P-l~K`|&*P@LmAn*B{s7&-}x>URW1dELgqPo zda3k=?Vb!-52bK=zr!Mli-4JVmc^gL z;jvnSTAWwAAJt%POBh-R(d#yN=#J{`1fi1jNyQ2j~mQ_$ZYb_|AY?M-k{vLFEvy@tN zbEirHo-{F3N_DsfscvxmYP3d0u3xPCxaP65-sz`Aoi-uZd{~W2AC*Xdri9Kr6s1zM z8233ECpcF`*3)4!*U75SIvnEqvjSuE<;zUi!1-&x#0<9;X54#YL(%zm7zf)?cc%^2 zAKEY>g6qkZKJ;OQCymT$N@dn~)1;~%lyXB(Z9)oZ#=b(DKdg{!oGT9W6wq*<1VU34 zTs=cjuqFgyJf7wWYLp+X#@1mvv|Oact@~OuPt;*;dmZl9)nQaEGbYHhuxxrJsx!t9 z|6qo2g)#nZ8>aI(#&@wp%(ub+tqu7FHmq`Ur&0BNsmX&T^w+_rw4_i*&j&Rm=VB5Z zt}KB$$wA(nQ$JR5P>oGLX(PvCLwOZmomPUbD`D%UMhQtMrcKtN%v~KKIiC*C(qb0J z>zkEhkmb)jKtD6iyJlfndoxT$*zp3K$k<2tpK6CPx#P`;5GQs!GyGgTP%NQH_j z6=H{IQP!E~$c=OQel6a%)1iZJ40E9-Y;w=Sz1Jq}m-0HbG-JSh6Gn3_lmC_TC+GFc zoJ;48wPQh`9pN7v(qBRT^mw%|Y2Ub!S9^cjztfvaxp7|K>V$Dx2~Ho9pgz~q-I@uw z_gw|g`AQ`9<9T_k!m9ad%$&^iXOI>Zm{*y>S6i+J144AD)JKP}%%2=AYewH!nb>sC zgeqL~EjVIA7U!#4)wvGZU_;AV%v1O?{^9Q%>*Z8=tS?E<`_Y>VGCDp|PPx70l$apF zh&DwaOXAvI?SxBlMbLT^*V%a?cziGzUoWXpwyGKd^O(EZq(oj79e#2?eKw2d<$N@5 z9pJijlolt~WMUkTq4Taxp5kVv(gNpH>M%)9rL{8L8X`sCI^HO&mm-tvjY^-q5G^qFo)V4`jU#a05sv0x zHF&i?0uck4V@+dB%yIGg+ay>^8sHowq9$YCCUvbCFvNnC0t*uAGhY2@!CQl%n7Tqx zTrvrYv;KnO`X)g!ier*yTmrS*BvS0qM4InsAblSLedHSJ$8ISC;=FL`iWEN=b1l<@ zIqRu%eB)T$YP|-z91H!F8pw?rG&rHb>v5b%n}~?K#u$E}i2k`EauY=KZkCOk9#+h$ zlMR1!gLf<#E=UxwKL`prkE3avpy<9*P(0ruD4H!#qAiz`Y16h;a&MPH3pOND zkTchcDlb$Ik>mCmFMLRm!}XgCj$k=9; z&U`zMNf;Y}fIK}iq6|3nUc|v@JuD^>ZAiq8^;XPlm5nfWD`p}a3olu4ylpnRa*lX0 zSy22u!E2N*C@wq_6z_QrzdT5xr!5RLym>NR*)P%u_e8o;-#`lsvc4XEW~Me93O zsE1n6lrd0zCo7IK?s&98P{b_YaXb|iR~Y{k%j5mTxphXqNVd2X8t9Qs*+)eRu9iy6 zqeLn_P>MO*Wmv>mV|G7ptT--1g{eMJ9M|C3t%az~`&wBd9M1=9@HSF|9dD8l+k*GA zj~?fEZZbKyFYLp)_1i6k@Z5Avfvqcr;CW08>a{YV zq?-*m=0iQtNpNYq8Yi#oaPXT6Kl<2k(M3+FOPMb}7J{cjWOrS7FGbXk;;_-dMs8*EKS_9Oi@(ZfXR-(Ly|H#*Hy{)Qk0`!9yfiwLcg` zuWB(=W5Tq{oO_L~w7YU4xx8T>akUnSW6aF!b6uGurwLCSRFwI|qD6Js!|(4kI0ue! zKYBRd39UWVn0!HtO4m#{Q`U|IVFvOQ`x0K*pwi0^I zeTAcWe&*RR)n86yo;cx9t`bAmYf-v{2{kx=N9B0123SamZIo!wIr9#4dOarQARx?@ z7R3Ift`k&f8>&TzluW!}?yF4`DLu<`(1LMFjF9UvI@N^qQa1D`*@#ZH65#wqiNGT~ zZ;ee*)wkj4Vkt?SB?!H$f=gd5c3sIt+gEapvq1>Z^Wn6U%bbILcFcv#bp{P&Hh zjrfydoz-Z;CH(Z1~W&Astmq@Ogm>x9Y|~w=4@e$GLvXa;5y!4l<2ZV_j$FSDnpx z$uvUhCAo9;m_YaR6cuMnJSrbF#btdFeZ+Hg*N`o+<13m;}53kFrs%CUxEO*`6i=t2R{JVr=*IUM^i%sas zwQnb7BidY1f}TTEaChS0+dC88m)o$Sg*W9^74W#G3O#>BBP>1>uOj)J#`;mkC#*5> zd2iU0apmMp9C(|9$}1T+*K<&UZwS(OeLaIsI6TjW;!WMiBf>#4=A4LeU*%IKL@8}J z9@Bs-%N;a)w-S~b96uYG5LCyG_$M;@YpQ^YrPUac5RDHmCM5BG(*=1_r633CE~_w} z*U_vqA#F2r*1f!GMK1vzSU;%7^Ru~rCW4v!IPKv^LiYly;;X{;8Zmf(oN-)t){VM& zQQSxYJFIFvHEZF-T>OB>{C<@uZC)kdD?g_m^ZskwG1i*Tm~T@Ps<@H0$wg{BzQ+8E znYoQ+{P)iHAn}-k4%H6Dq`^8|FVA`#YfiT-x>IIT)?*@7=)mzI*~bLeNjALqkWp`c z2`U7uG5fL(o;OWsKaRQjK_2wpA>dj|HST}bVoQJ-b*I^J@n|E8$rtebg9;6%>9D%E z8J8;C;1uOW?k-N)^Enu2Pw7}|&P4P1HVm)oL&M%M2NwWzE(Pre#%Rz}|UNpG8 z6DEOqK>m9bWlh+;#D-bJlIVUvDXO&4U|~DPRm?eFm@X(JUlVD6TQBq-!1Zyk9tT{l zNZBVS!p`X_aIGimc8|dIED@8RS&+z>YTt<@YSPpjuTE$Xvx;lf##W5Y78DjSg(~&t zdYgIP2A&3tQ)eTqi=g;k$w0B`-Vg_AaCZ@NB(iJ-_Z1Z9$0gJE<6cR;14q6mDx1=+z!i$R3BozDdNpZWaWLWsV?IB(Jw# zxOXWWPgaXK!kF-)Mo`>+ucx~r^W=>*cr;CfUSfqjR!|I=rqcI4jE$M&F7Rhe$DHqY z{(GOcOQtW7!@%|U66SD(4;H-NEhwVzi=-C4kaj2>$38F)9b-kE5J90kqNias<>)w5 zgRDqBG&a`$8w-k4PRVrUvJ4c@n06NP$_*@7%v{E)+KE)^xfJ{V(!kn-@!BE_z*tpX zN>9-|Z?#)%P{WvnIgF3azY!G6w&9BU#pF#KR1q&M^M^96-@mYxR9m0}U&-sN-j_{P8Y zR98VEP7=vC#2e<1;V}0RF@1s+O|A-x6GaX5&cQhGp$6ABifF)i{E@$)7*RQ%Qe|>< zn;n6xLqxd5G7dEhilkA=^u|?&vk4mPZZ6_(t_4@O3JOmcsJ^olA*aJJll>{h7h0iv zA}F*iQfTHiITkL}z?d)MyVZi$%-cydX85y9G}C97p>k+WOfGIebpH-qGXbCo5JmkF~g?ft;SnaD_Cux>}EL?`&NE$b8^> z109fhV{t|}igOKCvJ2}Te+dfvz+`GxC`H3W4U$i=CbOS?FU=*2!Ab*7<61^}K!d_r zdc;3qZfG#i&j&qq@|9wfgx7Zh$ANOJo9uPq(c45iv{!})-8GoRf7gjhR&37{6y^IF z=oHsMpIJMSeiso?J{z~^alGnmpwqG5P@fD(!v?(WT#p_ZEK$IaLYov`%oi-gD!U$a zCt5KyNTOKuIGHv^d0|W**O$liD4$_L^mswh@)&c6UFE1aUjv0R^MB`Vq0bOO@hwVE zzVEzn>G?t=*A&rWo)yj?9jG}kiFPlQA^VaBk3B_H$+Mt11jVC^i8Qc<3|)t7@I$S~ zj9wO;Ud?s!W03}~^@6`O91%72khizsS|veIN@1XSC48_$9f36$li+aT`fRPBsPH<0 z6wf>naaDtLkJ-nRmW|#=ne!YFPf<5yc*JpLcx@3im~*>RPEd5-&-=5M3?IH|(4FhQ zp6M2BE5B5)#B&ov!$!pVXnHztwfeWX}>mdC^AT06&za*G7TD=~qVAM!@SKn*JL{-1x@ zio<;b#bQP6qqTWwIA@Dp@KPKbc%JFlCh)2%ZXw2*NU-dJlA3d4gq1buj)yNTn^FsyW z;i>!Ew5~QaaQ36>K|{+f2$-Lpi6qo9 zP-ou5jsT9c3uMquWbdL?j)N)Qu)dWds*MbJd~d>R&QpD**t}SVz$r4EIK**Z!5kCo zBXKvScx02I`g|E`ob@ag(1}v6~bR z&&wdaD1+&k9OwD_-dp7edJv9q-UD-XuqUxq1d_wp)99l?_Bi%6#%WO1s=YatXuo(_+IyLtQ)IAAU|hA z`3O|)7J-<${G7CfSkqO56MP11TnNW1_Dp8*{*SrHnh$Fh3;3KJKgu!lnFw`H_BX!J zBdnjEIb0DDr45jc(Btk5JsQUH{%5}Y8G9b@))2Ay6X*NmBANwo9{HLCmzS(tGsl0j zI&0P8dd#23-o-=_o5%8d`!j!Xm7iaef7fU|+-%HU7(_hTF2doiN9PNyF?kr^y5EAa z35?bF9JkoXJp3Eh1qNF&coOFej#*}BD^9?Q2ahc1r{dhT-h!3GvZ3eqFWJG`_DKtB z-?iZGCkqA}Ecja7ib9U18_X7r^R(c>1PksLvKGCOwP}tR1DtS>e%# zaS-!4XPMvWIm3$0vl>xkHFrAU;!jBhQhHn6ovIG;AZafjO3rISWk-5a`EhbeW*nW) ze#h1|Wt3K#Ie;Htw6>L;Dn>V^8v|wJpC_Y$u1zR-yp*L5{&~xalM@y#b<_Ke>oKfo>1d<8Lq`< zg<|F%CGI>9L19xBW+_#eX;5KB0rSbCMp8a2Jx6LpBa06TQ3wnv8zd@V1~VtQ?^d8X@NSs#N< zo0(79t%cO2MZ-xtjI5x;iCtQ(tgeN#zZNt>i!RLbPw%Y*`skp4AICn+d3u|O1@|Zh&&h@uT1@3%7muVO@JF~AyZB0I){0&VrD#*n~=}7R_-R&u1~W+E7ydl zmCX3OnmHSP8}>)r(6gEiy1q8{gykSEn>matcC;U8L)-o~Tpw#gs<#~{zvSReGp;MI zu@1k~2In9fiul-YIFM`5LpC_9HhA4)52MzGIj3@PvXKp6OERCfmbLoBcBIN}T*Krb zurLSNk8-f@9KZiW4#x`iHny|Fy3Lb57IUS71MJ;pA8@GwUUaaWj6TH3sn{uRQdIG! zI>)@IVMBj zRbQIF(1%`R%BUXmCqE~6({elWSoOSU|7Tx{8_nEadskZCPDbwA+1s#GPG58m>dySd z>z)$y-sFVCkpjwcy}OkCio-o5=zPvWBhNc%%oz4Ke3D?)6bZ(g1YG_sAdU64ydDDc zvI3?bl)%V*R@W!&F_sA^w#Nyh>Nseunf;E99hBxQLG!2rYF$Nw*@K;!1LpTUmLTD# zfMGui>DUwp-DoVpzL`A%%q_fI#-7E|N-VjiLX)>4=)-5FyIqOrBh(0Ouf`}Z6`nOy z!#-Apvw9WudsNuXe#YR%O4PllL~3$Bls%wAdK>0#OREr<6N2LfN{lP1MArQf6dT0n z=U6a^HJnR(l;}`IjXCZ3=L`Alo#wOoF$A5Lsc&U$jbUCgJrkw)`!`QaSazBHFJa7iCh$30 zZGs}hgrYUfILkV#W-ogzx|wj2pSNP72>}n7Gp)&fqVN232TV9JG7~qL*FEIIoN`4o zdQW1ljnDUf*0{Fla!_=R9bJy(pvD9nx-POIG|z@Uxi+-EYeV;aIhfzfj%mwtFl|5k zgAdv9I>UyIeD4~cxg9(BTwbzagxUsavK`K~+2_c7o>ppu#n*;nzIH6?WP{HG_Mi0R zGpDm*c2PST@VRZpuidZPU^FrhdY`$(mUisxvBsD-;iWNlk0j&Gmz!<&)N~JQv@tp` zZ;2+ba@kdZXOcWKT5PFkEZt&rz^%~Y#@w)*>Fu`d2=ot5H&zZv4(#78FL2bD2xEWW zJAv`a8i6B1o*JWS>`uQ@w~Mj+>7Ie9&9?<+M7jo6tk%cqbhfoocXW=i%&sMY&+c_P zacXx#o34%D8~cS8Zk-~W)YcuWTNWU$|%0L-P=6YdB4R0J> zBS+s!QnX|Ic$M`)|2LjUjF#e6QyHGUlVR&1DY{0=klUF3izB57@9c#(wb^GPN-_SW z4CCiAMr|v@nq-Or4a7w|tPXi4?!!^iX5`hl8HTXDQgBe`k=^k(& z%pMIoT+m=K%gm)SYOJF^2xdwXX6mGTFBc!*8jYC9SV84yDsR*CRB34Zi z5p!FQEmK8&J;5GDFaDfw_9J>T-aFjM00m>nr}y<(b5)P=Jz2{eZNPy_?0aPY&_X{E z?U{SHa3=|E-Wag2Bl9=!^r*5t3E|9{GzV;TGm3tjN2_JuJl-BhI!!%e>6)6;|{Z!#Iw(Kc$ToSJeFd39fH9 zSn+VR$P8|3(f9WaKI%S zjV@WSaI6(^Tnqm5xge{Sd(w_}a_Y6nkG>~KN%-PLFKhVFwfYiNyi-62ck`={1Px{t z#e_!!G|CX9aIF4tk$F*>8nKgE&ktctq-DR}BQ2^B`vzZY;cMeKcZK;;j!DLTW+b!z zaiKkX2-%Z1vmW<79OloDx@kvg3-=W)vZJf(TMS_RWny1fTI=Uc8_Rpspx2z&)KXgf zMou~1zSF54tdETPNw?XTFHI_-{6kKtVW` z!`;P)F7ezPpCl)1o;O`)%v(Rqm)t%Tke)sMGRBqeYYXY|O75fiAfR>!_7jAKV%S$D zj+RrRVGAX~t|@UbOot;cbr3?dSoedya`8HJe!^d~=i-+yZh(&&or{{ee}v~M+l&uS zIX;f&-U){d>v}UEz1fDOnXKQjZ*W0eHa(n^EpdS>Y5%j_K`33-YBCJ zPa4oPiJU?%2r!H(pzbdP%x3K0LsdwNc~7E+1xc09pcq!yet$suUMN1 z)uBl>9oBI!&b-an8^*dNO}NOKku&G4PLXCbUuH(DLuL$iZ^wUZrB zy0Xtc%7@$!%IVuSe>$;?eXy&&skPmmicI7_s?$ygU&j3yj9H=<^Y|t^=s}hey_>L> zIFNP539L!nRbh%s4gK+GJgcPxF(xQHqeF^b3x6Z`5N&1sB;SmVBTcwj-h|h;&4`(A zLO;sEraC$3!J6{0%pA1c%l?p1_JoW#(CPADBR0Q6x-MX@mZQg{>}6hzb=L5 z>`A7wvQ#p&KYsRRPxOkDq2mSi7OdlV-araJ^2VDN9JlvGV0;Y?pDzu2fi>8l#vJ&5 z?hlk0Q1P{h&Ri3FpD|!2^GV$bve7Mt{ny=@uUu)x)d^O}dN6kuD=2z)6BI+23JU+) z5=HM8f})9?_5INXqRdn}(;%7JbDn!RJC$%fnf4gHpdT;AxWn9g87IY&P#K(S$l;e6 zfzfj~M;z1O@@5V8E{VXH^~?`^6=Ap~q7Do=7sdQ)on+*2oxU!TJ>#hyD~EHxV1Fy# zdfmo~hPTn&!Ja|(>xC5viiNBzTp7dTVt#wZoCG@hYkoXas8eJ-ZQZM@(?sZ=>e0ZJ zb5W`R!|!v9ceY}>*@{YQt#Ie~U%xT0*9<|CJ&<{2=D-gXlPJpaTBY;4-Q1W$*GeUm zY^O+j&WfZ}BvXDHJ*9n4;vU_MCJ`G3hv#e%mf0rMv-Y51Idr+^UupM)!i5F@J5ji z;mFtX9%divLH0N;%wU~C7lHS+4d|*cp!5j#$von9;{1F2frudH=}U5+E4GJyDt$Ot z^4|Gc$XsVz)@-`)e&IcByvAOlg@U5-EkRLZvtzU)ol8tig5_i}FF8f~Ej{kXm=zkz!kD{y_|8478p5*eeo z_v$=*E}ybzBaQ3+lUnTI`l0R@_NK+@@Tf=@N)#}jk72*XB(Bd(vhQ4BMsy)-$VU+-jN37j|vZr;tgYZ-eR z`wG}}f%`d`2l>)ciLIs7*j7!6Qo%|DNOXAKh2!91EhhZ(#ZA^>_+A~RjbXoFu`EQk zGGkhQGj@D2BXAbyvQ>8Y9nHbP{W;ipg7c{VTe#|MsO08FwOaU4{7z3QXyQR5GyJH{ zZaIzGUPu)ybHA#O6Rw8~2+#@e<2o|cQ;F4#F%o*JF?cKUGdxEIhY~-Iu?Hhc3(E>E z=6&OujB{$!mt3FCV|}%$89h_E&RN2Igr6DZ7H~eDY(v!m&RdaOr_|%Tm10L+T^lq{ z{b}M@A8I&NPHQ%JQ;n-$q-xi^80T9%Sg-J%kxJ)KaN$Fuah zfVp|xTf+0zC0GTIiJZSUcloH8gSr|Dr|)XS^kS}OmlmV#TD-o+K75{^)}>+)9?SlP z;U-usm|^|IHKLapho3Vpi{L)AYrH;rHi(RYYBN4N!~BVDxcPHtmC-jrpHLD z9&}GkQ@g*S@#lIV|Q@f zu!wu+%SPbmBMsWJcKqY12n%z%%acSr9-WMhXSw%@^XG>S+34c1z|_@>rPUcPKjNIq zvG~Cw_Q+M2D31QpT{tc_f5|a%QzDgRjm>&6nJS!2qmXp|+=F-n6)7vlf?jgeZNeOW zJ1HV6%8{2Qg^}}n{ZRH*_KZN@!Emg9wh+b?u5(yh^a*A^_Z&SYT{j?qqX82yh}h|! z%|2c3YvTM>(uwD4DElkz*=WsqtJwn9yJoZYbWl*d<-Adzb-;IAM|Mm$(BSw)s@FP^ zKD|mNduKg0$mSYu1NQ{f<9@d4-dNU4hD4heK3CGf?#BK>Gy4q&u$ERBj*sPd&V1N2 zkjMJaDiNjjvflmF02O18+a;~&)RF6m%2upTWR29uz57zm@lOTCj+267I%}Y>PVriC zzE5i=Cmt?y{j@LwP9aCmK?ICtaGG?V;|Rk zA1-S!+!}$vXbogh5$Lj;`_7odPviP+MMDuE=NOQ!Y_*{5 zR_^KNxk1GVk%GB*VRLsGYhm6f zJyQl>55^mBWVpLrhN!XOSmdHX5bxvp>-e)6ShvjUslmH5to2Xjo(`U$!=Jd0OyO~{ z4$!zebMKr(!v`jRC`ddf)Rg1M4?M|>Z!Rbvp# zJW!<=R#ULFc^`IIo{vTgx;ThNnP2`(t&#fDk*WJ9($xe zWgwL~(KoML$*;VCipx=;KBe*5+za_dNHt8*N+<`%vw4 z0pi3^oSecv`3=o*-Dk(KvhL)PDWD(waY}n~F5a4nu)#Ul5hkUlMhBf*)EC?5N2AJm zj$LzeptX5WmCp`}e6ED^yJ$F4GvSh!gYv~>^pmxNj6O>EFV~`RYtENvYzPTzOlc|s zb=ZG&vXl-9?C(>&3D#w5%qGk8EH=!vNu?X+{NtwdThdt3pR8Kai_@QPRPH=TxV4tKl{agcH{aw)`t!r{z0A# z)QCHy#TBmWuB^zxy(BqZdGV93$FdKOYny!*6B;o0)-T7KdQLB(#kZ7bbu${X&v38x zt{l9W*pRx;WeumJ8e=!>u#fBcPbGPrBm602qrg4QTvsxm`ieD!Z3nnEoYH`Ly~(Gq zFO_(~IeG%ul26Lpu=sK#GWHcP^okOfhiOr>r3p*-Ft1)wMrEuHDi#~cHMtfeyK)|X zk%PYRo^;T;kb4P3u(zlVo12?3q@NAdp46ks#~DYp4nf`q{w#~Zj`Snpz;es;Jud57oVeb zn{x1Vl$5#-{Z35^g3+NF_qx2!#CFyS${PJ?ty}_$TL>mH|ND6q*T{Cxo4@>G2?B%# zO0053qtScz7nir=9ryZ0bt$A)KL=!hfEG$6KDx6;6Pt;NTx)M>A*WMK1aul7f{)eNH@7wu$?i4`jr62}asi3V zHH<96_Zbtu>0^U?XICnWaDv|tHTvnaC^E!^vrlvQGiJQ#Qau5_H9`<`Rg0AFnON~4 z2iMknQ{=}&iX5WE?Fl-ZY-&PbSw8QjJ*a9g)&+Vg(Xq7-)vf&ZhH&3H`!rh)WxnGY z_eYM^Vfzsi7H_a2rJN6Koy(d-Llu5LV?QSQY6p+7qhpMmy7Ffo6l<@NXgAmNbQy=A??GxGhCk2$Yk>nSIA?d45D491XGXz_@7hlq3=W*w7~>Y0FvUAQl_ zvTNPFwQruR2|e8cYULZ!BmcA@t*y8{N;eZ+1(dK8A; z$*^02ZG_!}&F*Aicd}W>MquCTyuXjnm5o(h;=Mi;Wd`#6)LK!9?@Oz}9?~;HfdU9cPoCQ?&!rGm^8r-2`EV|poT2V!xgFDW3atn6f$=UiB6~)|cbplES#x}0->&zkr|u8Yg#|@R2pw%s_>wYtXoT3}&`rjhaYp1Z%y8)Je4|p+?a^(b#>T`2#oUtKF>7 z-g73)zOnRNnWZC5Yu(!&7>Eo}#g~EKE4(v(R+i@YDy1Z%$(xapg#`FC; z+|i7&{Q3v0E3`M?@0Hm}8oVtZ4eK-$zWGw0p;l-&k28weR}EV}F`%y0>rt2CzKxiY z+AOC=_@Ec-NYCfY)@n@e=mM_ine^10R$;-EXebL2BbsAJT0QDO1B~+iCN()nqwui} zIfzB9A6eu7vo~J0UR9%rEgH)QnUK&s16$9#(4c6dB(SCrkJe*jwh@us7m1!OoX?Jz zhFw(H%lEz395al3&X!lG&pnnT<43D-h3nHjJP9*Lk_%|apLc*!e)Lx3_6}xF5U={T zDf1AB0d+r4ozp$$q)p^L+Q+Z|PbU86dY&@dB>#3)L0wyq3f#YWhskH~eNTOoAPXzf zQ$`JtC-pIJSK2Xy-rS!P5(PU{$QclYrZFZ|<30@zRcNcz-<{u3gZkcu88KuxxG?~SZzPZQD#@MMfA=5ttZ`<;9OG*~=ST!oN zjl#ffCZylVz)9j)FO!p{O=IS6G~oLlVZ!}~nXuQVetAoRG+scg>b@TLD<@%_yB$KE zW^3x8-R5baHS*ujoAKeh9fxmoJ#+n6u(3Bd7L7rDO*s71j#AW7hB?ggVW}FosE-Pz zpDC5+Si6=AZD_+}$@FHw)sj7Dq8a%<#QWAOw5unx_Zj7f$o0`E*Vzoq@Jw{!zAk&& zEE6hG=j%nx_o*4bcy6RLV;^-RMU;i8zuFpucAw4g_+W?sH-)zLextn1Bj?9HyZdnV zAgk%yHY>E&=kfAxvj!Ww>#?|-8C_;m&%2tvp^CXFF6zYib9G-sP1FSHj*2O?_vabK z`+}M{EpzBbCE@BtJG^-=we6iK6R&8Hqt|0Lf8OaYs88?3^L&s=`cZ>6!-tx!2jtes zMGc|;*S$%y48EYj!wGuGCvslrnC;e?p0<@n(M9le=Dl!*=R>hFnaF#=^}lkTZ0@f@ z#|7m1CYn(7nH>$5@cb;kS8fGp(6mVmCRR0b9r62e{nv{$OZ8J~)NB)jo!3nWV&54{ z%rx9-mLoUR=+RY=)Cl^s7u)gYlS132BXRd##AgRf8jyL@f1W#=i2=LJ}@n$9`tW?gOBsh?%JoHZ(V>D;I0j^iLaaaot}LoIkUc#j8MO@WqVImWpvDTm3VkuqE-)!&BymzG+8( z6bLTSqoAeT`8dlC;XeGFAakl3W&h?R$=I`3?DRFZVOGvtdJGyJ;JICzp3r&BZ!DH1 zlP@I8wC-jZyWJ?K0?iWUXO?qo$y+Q<5RWrS(t}^G9`{D4HfFj1-Y6aWo8;o*1R4ID zxjysEGB-6@UN=sb((TPMyh5VPPfnE5#AizMN|Y%&ql9PCtN2rcu}#(Z+pfY2-VN0n zsj<7W2JJrj;-!`T)1~yIHX$Z)P=jG}e9>H^#>|R-SaV5(I)NIzU#mvfIn>&(Q{z4V zp0-|t`!9U4gMaQpKAeCmRt0J3iPb<~LxcPBWqxWR4k50^K-06+ZJX@I=1|b%m zcA2=)9X%TS(nE2Tf3`CpCqmC0Ha+^CipESwG&U?`KEW70Mvv8FS#kPuePU2tsC)bo zg$dL3SkaKW$PUypwxLILtsar-(Rf6RyWu%<*0cC^J8^yU{}1OxBO^N+VFUGO+KU`U zMl>QD^6o9D$16TVG}q!c-sg)4n{k9(PwzAn-s!lnXPNPm=k!1yu5H#s+0=HoZ%STy zvKga>F^@6BjPZS#3oz8otVU)_oHe8B0De5b)|0YHm}fF!>~bUI0)3ZD=@02f9b^$R z4C9QL$b0Il-N-Y7y7r00!<;7SK9Ya~JkRIa(QUgOXTN43zcFjAX_+ux&BQ(8EV>$Y z3>0E5ywe}AU=9z@k}KTr7uIKx^UOrq51Cj@op8_2c9?ihwyl?mbG)}75;rPGtmbZ- z9d#m@b8*#l?2W$T0n(oN$by)Uxoc@-ee z`JOUrtXghG(Hr)K+N?svd3}AQ^gusZ;qVdVfjScK-b)^bYouXgjSO2HD4*$1Y$G1h z;-9*5VzF9kTkA=?OiyVYtHib%?1!Tic-+z@ElVh2eBqM40SfpiawP9Qv6j90Qsz>w z^lGbs@AZ7y_ECxCA}(U^3aq-JgwGf17Y+HME=w$TTE6T#qd=WVC5jUR|4~SEJf#=0DeLxu zW*t_rZ(d1$qd~QB;=d6X*iVOwo5G;lMNQVoP!u~Cj)!qNDA%%{KORa?pbn>qnG~22 zj$NB{c(_If%T@9L8R5)wVOHGRFg)uYhKKugIJ-O)S?_glvG=)4&a@wUg4BY{WKcz* z?SnX;_v}mftN%87``JTmxNX4C9n4lFelWj@0n1byun6oy%TYH)uD%v|j^#%U7&eoc zKV=O#IL!dfWdkl=HDF%rIMlCC4mLLyDdi2gLT}o(%FLZu5{HUr1KJTw&@y*sOSS?2 zH8Fkzk*4L(`%voNy{9#CTy zWW&34?A^y%@rKz9UT!v|CDZdt?&t3-=@|FUie-nacox8{#j50ft6A}PW;)6~p}z4V zySIZb_*j}@su(otuh72fZuYdl5`WhEQh{Y{ML6?Iic>ZhXKqbYHtnz0Vt zyyQR-dF>xr#Jj3Eux~5-%a=}^tn9?MYzOitIM}CWBZeR2=H|qo_sm;jPyb~TKaPL5 z4tAjK3J1<~bfPN%FE!bTXY4K0lui^K$A9~q*>e64OgZu%PpEA?)|0%ur{ax~gktY1~q zX4{17xa=}{sD5pElBDz(F?0X4wYI)x!{f(}j9VQAnW{?=KC=?kfgRB}%fCz|QhVL$cA zub)yc@tmGkPxkRn>J)Hhh!79%v8i$RKAKv^Nz6p~6o*1j;tS3DuF;lA$b5yy1zH_fA_Q&FVdMt*_=ALRmeQ_yjXlgMNBPtf{Ul=fS zumP_9)IE+jpjom3%R3PRsBM7Pj&uy&$_&NFR&37U9++lD!);bfDqzFG_1tq~=pRnw zei~uLf)7@#J#NLSYt&D0@4Xyh!zk`O$0aMCa*vvO+UQT<{_&*lIFcI22KxjqtJ#Jaag)E}xpCUG(o4ClB|F*{GTHjGtou;&umWbYR9KxOcceONBVm zi2HR2_vi`kt+C~qr`q3vwZv*WuXf@|Q)*9+I`H8bb4e!gYw-JKt#e|M&H<7naM;|^ z>K`qc);qY`>9q^nT8?e4A6$F!!P8G~CR(I$pH`{G-dZGjw`KR3BEh}imkHi!7}P2v z@80R#-L|)=-`sS%U|Y52srOLJmJ=FF@2F5qDYgXhHM$3ns1ns`*{H9r`h96 zSyFFo@YGfNEkjggEYn)tu@oFrDXnY#9?ST%H7#p;rw1Q(BwN~)8GqWfCP8{yljPOU zcxgaBf6XV8c%&I+8T~#1XU%eZZi1wE8pZi6LE_ueLpC-=w!co2*k(o? zO=1MGNpcpL<=J7Q^jeuLn-f#yk9U%6qj%;>Gn4djH_C5%HlHjpOS9D}^1ZK77Sv;g z6*DA8MjGW4{i`{?Ch@A|htV~OQ;hS4;-?Q@cl1R)_Aw>;X^X#8`48k`_A zMkKOETyMtT9n2`DWrpH&)@!UAO+}M1@hY=4MzD_^NN&|^!sOy+ayDkf^W)l&Wv%F9 zCiiaUd{v;1v@_Km~lcs+MICuRf-We8)e7J!*=YA&qSX@_ND7G zv5|f2z;W~@FU!Q_0-5B0=!a>>T$W5b=BCr*)-n?(_<64CcHF&5%xnp3%`kf6JhSlp zGO-%sHEmC`US!R9No&V2elK(3EchB(j~4#F^QMz*4Mq3RU)EF#lKt&{CE%2=`1jFB zW^6&+`9t0NJ7xvwa%InL1v<}Rj>pk3Y@wHag(Cuom<4f}dbBU+!|*$nHOUO>#k;b; zm>h>CJTo7VL+`c7iY6zl^j_F-vapp|T;$P85o4vk!BXJ^PHlEzfQh*FY6mv;cOvn= zhqMdzkzHPX;<3YD))iLC{Kh`=X{G|XpB3oCd#wQPoBXBBOFE@M+>tOeHbvmpL;6QX zl9O8;j-%tlaHS$^qtsYtz#4Gbo!Y$>aky88HBkxXAhMq5a@Y#PL!P64^so1|;^Z_Z zjxNeZ^FdDd`I0wU#7vXV)N1ch$)f~~+@zPst5;$*4cRG^UphMXz`3*_)$)TA9pfqkFU);J{$EH2Oc}IwveARiC~^Oc}4$9~h3DUSW96Y{YJR4d~aJ z8vn0+jtKf!F7ocnXPwCRYFcj_#$Beil3JB&W2yVx$Xwq5V)PB1n4aUnibyA75}22* zXV#U6O6Gj`lMOmwnc^ELo2?CH$1`Ti{GdMOsuBlEGjD4fdCnOMw0!M`*goOV4(f|8 zws0Ko9L|iAa9lEl!8MP1BJx95bLr{fUEQck9CQK9Nb|74y^jqymNL`(r4`wCY^cHe z^2MEO9Bt^ph&xV{=WCNQlG!wTwu|Efq(Y8b>aFpWBj?zg82n^_GEjo}9`$s0$<#GU zjOY3(wc8DcCn=e69)`lcI$#;sG3yB%^AUs`V(J>M-B9vpgEt`eeH^@9%xH{?Ls8zh zalALD6|>=1mK8D7gJcywL+p+|nYP*Z#k=b(*YVyj)Q4QA2GuiJO3@o0Fg;oRq3&zg zO|$HXNRgK8wbKv#VN6XwO!=rm+hAXGP9>*aDF!KHc?K$CaD1E|X*c!gQjL8y&zOUw z>DNnT4&q_4>-`nV09_5RbZp5kQ#h`K_ zp64Fq@%daOoq9ZfPOZuV6SJQ=qhJrQ*gP|C%w<+UmKiNlvyfxRM3wc_Ve`3Op1+50 zJdb|zdsn2^A#RvL+wl=`r4VAw)T_MmH_2jCioCyTltauU@ZFXwK01?BPUdWhTwiQ+ zYH+4@IzWBHSA{n1utK|$*m>JwN^RV_WSLw)S*kZr zk>p~j^5{&mcKw9nGAm$7G~U^W zhq#%s;*S}%d7oUqXo3$pfFJG6@XN5HSWG6mj?Y5c6y5PxZ98B;Hsk;yf*kvO)}+wWV(~&Wx>3sZA+OoTa20 z4nEJ1LgYhMXX1N&yV7CiXlznN6z{S`+WBfcpLt zLOp`nD^UJg=r0f0f2}@C-Pb8M9B-_^ig z%=}Bs#*XH!U)Pf-9nXB&7lGm^5-4j%)5m#4Ee9(G%FI+|=RRcqO>hBpXU|oZoZ#KZ z3bf4#!}3?uz;_@&9utN)55h2UHRn1s=l6cdISh;9kbfc$E8a2NeHZ`Sm9;)K20iy! zG4iYx@%wF<&VRd9i5Z9msDCfa-jvVr^{5kP8hk*Z%bcgNBtX)A17!DNmH3tOllV2w=K()0_QCej{#5o%@Wo$5&=Gm+~gADdn8#>w$*N@&T z_8_fSI$=ERB)8#&YdL+7Wi|4qpGF=#g2at85n}1*xHP4)Z2C`g%4gW*<%WLaU2=h1 z_~(1wQ1x;c!cK-WcPt#%65)8eow?9I*^e4HAA=Z9gGO;^#Tw{~&4AmL9rK;|Y$oNHIEdymQSqfsS;z((R(C&S9o-G&L&SxPAr_<1ttfZcfMbD9*0v<3#(t4xG)-#@^rA(78LX zpnQrnW~NF(_B+i!n&r^=REc{??H)5Aa?{DT_S9ffDmB%InZ?4KgsKzBqqNoIBz1$m zCdJ^GgIH~IYQ6t9A*@{zvbUHqjy3q!-{gdNf9UH|dp4im9itsrt#+(YtwaV z2k)9?^c0?bG2|0@Ps9vVY6UY;a?vperEFO&S$Jw?h)GfU?lDe_p&e8wi!y_fLC zb*`bnA8K^YWbRFI=DHYS;9ffh_p+HQ%zESa2YS~&vd=of{Gy*`oS8?jz#(SoPv zcqaTxWZ~o4Oln9nu`Jt;iV?)fjeMU*DztOIkjrbP)SjKE&^}-d;!!9h62s4{-oci9)WmTS;(mmZyV$DoKl1|MI?piMF6o}8nf zW1|^6Ba*Ph$hxBwy&b{KT5&RO^at}k<6e|%+5PY)?MnKkNq9kvl8YO~aezz6h>CV7adu@XuB=(F!ZjdTh1?j}M25ky zFl+37R;UWmBX0JS?N9UMz|c@gngM^$w_<2D>c!X#+TZ+<)?a#~mLnEZUJ*;$l#O!l zJ>)fW%1T@f!SnCTechXmnx!3R8|^L&O6ADX<6)>YFBZ$A({cP(HX^or%BC^-5;u>2 z<7UL0&sp(!3BOKVZ}B;oCu3&o@Qrxe)^AoEzfBDHiLWfCuIlOne*GD-ICPSkw)d%b zJLoBS8}gY$ABvFD^gSK7!gDMA>>oVkK<#`vQ$&YZr(>~hGjZe14isssmg3>LQjD1W z&8@MxGLe|rUe4@!QCDVM`YkP*ha>a@{lyCU>fh0aRM10ecFvV%<`Crb3H@wn^_Yc5*d*v_W2>O4Wr(tB(b*|>_2|^N)h6xUt^ig z&%P?3-?yHMzIkY*f1na6g+g(OXYo64dh{C+U!EHv>$D0SEJNIrSfRZXvGF3zd)`ma zTtL258xaa~QD)YENkO+NV#A1rmtgO-gEW6JUwXf^`y`e=E{}O;qt$+(3Z2J<3(b8oFSArPl18SVHnnuwa%Y(EH`9h5&OB? z5iXgTPW)73fcvv_EbYqYY{k5b0M;+OdsqKsz##UC=amlT+-PK7&L6q_JRHZy#G!&S z9jcRDS7YnQ)MtMrH-a+(co#M*cLsM0FfW=sQol~WrN)XdRPW36M*ZoQD%n`|xQ6)O zaEURD+Wb&@1E~9ZT#7xOvaZ}FFLdEC^B;B_@Q`==Top3~j(CaN5Cz`#)gieKvmH8G zQHr{)+9T^r-Cy}~erp(RM6x!RX~lt3e4fqpn4Ha*=GNZmH=H@jrRf9d^Yn+{A$(80?LokLo@8A#{8qw>r>5h-=JM5AP!~;&9h@}^d@5@sMl7?y|g!}7c z1sw)8;OoQM;0k-k@<%;oH}RHsX(6~BM~u2N_w_CMRQ7txf0@-a=j*WkW-LxDq7KfF z`Iz^;WLixH+!}>qaW4aQF63+nVg^e_F*o5{uADW|4>FOtu9J!R?r>n?bx$#F%9SzB z5KJTnzNaO1&}XSLec&St)#TH9QfKGGybE1AyvK0C9Qm z#>F~*QpPV|!aGx^Ol*AT9?sy}LvF-TTf$qoq*Xy3^u)yrY$vxf)Pcs-$-Z`1z`bq= z%J7`I&iZU)ayH7ItReT;=1I$DI&5xhz?dRdto+JZ83WZ)_hG&iTq9K@vyjq{vRJ%Q%*ttnb{;&c;1E*k1t0L|JqvOm76R6KSHqe zt^rX|%pKtRA9~PR{+Y@3Nv!Hm73!A)U_<-hOWE1f&5(QL3DcW0U~>J|BG59=D9@NV;NE9Zp(yLB?!7S#cwPl7+Fnjo^MtSB*?7AxR4GWuL zy+nPYRiVwR6fY^mRB#LD^8^!@c*Hy))*~TZlcZa=H&$+pLa#PvJRWPuJ?bTAO-YbV zZYu0)!o0kx%q}WNUpaf=Z%q?rQ6^_vj?&{q6#LUJ%o_4y{@ROulFeBJ{`BA{ji&D4 z5dXad^ULTRxn}f1+2_p5TWG@SqjoH&kJCl%N3@EXiivv6Xl_QKiOfTssnCw8W0dM` z>1FM%M{a}($7+%1XB~As)-3C(BYV-282LT=SEKEiO+DR$%|VPpI~tzu7pXdb@oBV zBx2>ms9%^*y-AyRS*K-PApSHtU*EVN<<>)Bnd^Td#C+d%= zUn|E9@cALE+x})QRjvtlJ7%Cby&4Z~%>24T4=VeBlts*nBA%UTP-qhmF|(_J3QbRP zPSYzBrsZWoz0-xE4UF=!pavbsM*|g;@a$P8svUJ<+^v1`CD#u(=IHT^_|Dc|)KKhm z;a(MLXPz?q+#Zd;*jv2M$-pW<7v{8%m*COVg;k>t^qL7%b~D$KI;P(p_lbFp2DNH( z-pF?9r_wW!Nd0VDtWkDcQDJ9_9^0rBw5=xYK1QJ}$eAJc%cwbPjl9BgW~HCCqY>Yi znOrA^k}8z07mdwLsK-pSBlNQie?pB?;*Jmg1VuqhU0Vxc^Q!GGxF1fG&9hV}V%KA6 zFX~dM1JRyzA!k>D?4iD|>Rvs5M4FKGE&~gwU;EI~C`tV|bMkg-iT-4|5;&_GVW3aD}##d7lJRr#A0tG)ztt zTF2V4-iPbJCPO!UF|VRLcup_zCX*JlA@Sby!2m2=c^FT<>giPRA% zX274dw`wQ#aZQ=G7Rz;#Lfs!Rp7IM_SitA;kMu#aEzC;GBd^km97iRE_SVlt8U0#? zSFh*dS!Z%BTbbp+_0zAKNnS?#Fo$w3<~KGWcoO|f^xDqm`nkrO4$t?|__~GM&Q|;X za$0Y1-7Cv-RY;X+Tp<_px(M+luID~&jZ$)v8v6^=d-t!2S-f^Uq2CC5;wAYBHB&st zzGibj#@lgvAp5=ciL#13+9c|!&lfXeNI%XJxI!#5D_)Af_90%y^WiD=l^v+pW?kQ# zz4F%P%uiHsee&mBMU1W5D}`2b(j>L^@!V*`eN9X^yrmtNJ1Dfpa#E#V8_q&2LhTga zufpBg1Alj66m@xB8~Gq&aTL~2Kiju4UxzrJlPk=uKRHw9bredSFmXm7^U=5-LWjqT zVt@u$?@+(2Gof6a4CvJKY*$K@!f$-IAE{&AXF}QIe0|uH#11q{lZEW#mq%l7xEXF! zIirR8?!MF`KYOggpmv-O^vHx+Ettp8btU}xZ(JugcSNJ!CKEd9Ie#{gxaF02xx1PA z?$*&Lbkl^-I-c`|724pQd*$j}uAlaL6nA5u9P!3QHK;eNpD2Hpdn1tjUSqDGIW4G1 z=Ig)WSAvu(!EC+CoV{aYo?~VP993O-);L~*R6bbRfj)LSc{)D7=j(jjpkC6#^SO8{ zJ#M~azQ_t+@%6uKf|dKRI@jC( ztDdn>=;`2$ibGDX%+0Wz{I{!Rb410E5r|9TT=SvcyHrP{_u zryA`z-0H{dVyzDq85vym*Lus8;6s+srv*=+y5W5~r`q4G>@TiZRNl4I99~7!&fS|A zJc{dVO3P%ae90_GiI?(w66NJplawhyZrYe62dbIn3+L=K>y;$t8%C+}Bt=}4O;Tj8 zS$eGU&1W=UYg`{+XOMsG0A|d$r5|oB)5N><=E?ZIk(;LEWLb!XXrR$RW3c2@qQZYLC$(QIpsCfAP(jXK@D;257doAk5#9mkzAU0eJhqaGqL3 zsF<^JhnzJ(_hd!Z73s|AO(oCm;mFB%MY65c* z?o-eF-H!4N>_~2x30Eldb*MjVLi|HP{J!iUW^80;V#H*g>j!yf@jhPGh+MY9j!m`i zVNSa&bO^CyPq$2LnnmpII?t1Z{IkQ3Vi*SJZJDU@R00pL1OL3d3Mx8 zmRsO2C5zXW=D$2-Zq2$fw6DKBJE)QYV>HrYgolj2Qb+u3?$R;VU*^_oBpts7%Gfzx z()68|T$|}BJ-QP+S15qCE~z-uCAt5SYh@;5i+wJcmE)3=Nz_cu{Uas%B9|a2b$(N1Yb7kaaa-^KE@M8B5v3e_T;7hLbDXl=}JOy47 zfA(Zg)i=r|SA*zn4OXJ^d4B)J3M4oEBX?WnNe=te3CvEMxmmD%if_L3uR5{^IBLU4RnDE#?(dx*8f zq|j$pIuw=0>yR&;UEv5pk1g~HPT}mPOdaOd2*d4H)IClM#oGJqmEW;%I?Oq_bLd$k zr=qSFhtu7ujam_l3x^CS4bDJ_X6|A>y_MI#W{KrGWabQiMY6v!(qq~r!iu5njV6s}CSy)IG4*uxTV};^ea|Jpxk8zcQvy2>YXMcP3c{avR zVdlaE2j;Y=UU7>9$3JCrUKZzFRiy4Qin$pd-lKqq9?f+Q;9NFwbtlZZ)L>a1u$`q| zaTd8}FXlyUaG*VBn|ul)M-@m-)nNy&hdc0_eX9@g{&`Iu=s(Yar&}GE&YXTr0gVK_ zt}p&$RPv{)kDSo^NZVYER6FY@Pa4z}Be@Y*DV3C}?=AiF0|hTMGN87%SeALnlotM? z9_uYt26L9BkFPA<;wg)kxJ%AtAGtSx8pqv@By@ncJe{YO-$!doV0lkz*~D9}3{uP7 zjs9Zu^OEY*>PvLETK4ZFR&Z5;i;WbV$B`$M9e?Com>cQ`a83vReZ(&2BW2{ttJVr^ zE1oY?xtH2@cgav{6sIyX5D>+yo8x&eJfAJfwq-I9eU=P;BOWj<;*+Ro@kY`rSg2 z`CA9io18fvti!mBP&_FbibKUC5YUDHJ~0GALv;x7(_!=q;#=>jp)AP#_KsL4ap0i7 z%z>;!tieM6@Gt|iB8Zz5-T+5`=922;aD)46|5@r9xervw$k(kS{&U=bx}&Hi*2cj) zkn=8@8t{XA^f9raL7faZaWxj*>lyIiTr3*YU>*nm@An#JtcGyzm^Z(Nj#|k91`I1i z9b*`^8B?hxZb_c&EA=dm4Cq4*O_ym_>UnI;-?k!@8B`yqrepOzD>}8}><*O`GjvuQ z4P+K0F_j5Lx$lNsvEv*0r^8lU3r@$`p*HI6IXBwIeeyURZ=PE5*SB<(e#d>A&bc`J z+>XDj=-!WW@+PID!HINCpGzFOCV90ZHVpk~#fez@re|?aZgQY9@zQ^*anJniKstXn z7>L&dIB|DdHk_%%{wxmM{X-q%nQWYNIPm4BgBY&^y57t(nk7 z*Xdv>U;Uw_(%e3la^q?S&stkKt;VNSr|XREE$ z(bQ67Q8~-~$EM)x3#+8vsB_V>(|9BJ^D5t9@8wrdEZhFrGWLp(rA_|}mg#>VY}KYh zx8N!h@3pEnqIFvH_BoaczauPBktHmx21HoK54y_8jGvYo!4q3vEjj(f$q!#GjS@}r zh5Sc!+e9h|bm zd-!609deBcYG{Y5k=ISdj6G&}J6SJMAJVZUJ#AiUoKULqHC=^GyXcSM{EH3j^}J0Q zoXb;V?GhivrTM_?AoUyW)O5@wesO|WQJjicCbJ-yQA=sjW96|J*r-+b%v!NVb3Gac zMZ@ig9{ze}Sbd2`hrnnQzpF?65Mmkg$W@hz!K|xMxKfxpnT>i>b8-%K2lKaGFC%KtxOM#=9cY%6ER ziN(x$cJ`Bvkq+eojF<;sZk8%oRY(wnUG9PVqZHVn($*9+0o-J^SxOoHlAZg zEvp?v3T2{hiA?Nf4VpSE6T66W;JF<=Ggv$FExzTX=9LR7X`@0 zm;TI^Du_}m6xbZ7z!qj`&wZ>w3^gLJT5&iJ_GF&jhje5%W=4_1hDc)lk$0JQObyy~pAUFflyf_GI&me! zL2RX=Ox)@(@5u{2{^=*%TKLJ_c0MxXOrE$!6hNItZuq$(U*07vP`Ma05)XzmCng-7 z{^+o2QW*Ll2*a4c%;ex%+&wrBA6N64A`KYc+yHM6p7q%_c=Nn9Eg&!Q-HL?yXK?Kj zXHai;!go98Lsg~Ln$KZ+PfjV#iKO}Dp?-Nw_1pe3ZvtmZO>H3gW7P7tBr~KsC{UQ0 zCtZ0DUS=k;UnS~Pp6JkM9`7^eZQbn|2ImLfQ}Qy(O z)+Oc-_M~3VXodTebcF7s9;D3~6#nZ2_D~mBpSsVwC8z~iMt#b12Le8MOHY@VY#-q- z_m=xf_7{zebp*)oCQ1xFPVYjL8&FLNY3v4tn;ZJ_^%*lc98Z>#*VquoS(IT&_N8v` zAT|9(;?V6AIikk~jN|WD?oxX%)Ks2lJ(ohhA=ZYz)DK=~Z5P&wdW(b10Nc-*;H{k) zaf5osNb)Izn@CUhK$$IZ#nDDKUy$i5q&yN%@)@ylKsOlq-Dk`I;}@USUuFN5%OhoPV%Tk5W^aYu7pkZp8oA zGkL$Xb~j5$>MmxKW=&5Rw>ldvx?3yR{L1@$Ns zhPRn`yD^;2bCM;y8g-w?sFx{lK&qVQ zT{zB{xr>}{)J%har)W^UJbj$J>x!px?&BPKafy>hjEcc8HSwygdRPycP`N)}lit*; z4DbteCDkQoG*`Alia(v^CYCP&P2){A*$Zu_NeA7YKvo{rk(hp)ZWIP#PD z@d;nteeZ{aRrHKLqJHN)^OAX&E;*&ggiA5hsU^WmT=K#|&J694gxi`V{QH64PVxgy z-|-m^Q&;~o6L*GC^GSV(atFURwXm7p>0n-=5`iwTe~I6kboo^ z=a($aJ{Tq8JawKa8eA$uy^JU4a;LI(2xH#Xcs;<{VAN7Q+RbA2=r=v~YnkEEDhYRv zGMjM%v1;Nh0UgY^UN8ysPf*)*kZXrJ)byKntZGH?=iix}O`_0F;F=kuQ)-pO*{AZg z>9Udfrbb@U{gW5D;l{FOn!of6R>?AQjKkdMpFCa=4Hvm2u(}eHiYe*iQzE?$^@AI9 z2#yNFttnx|sW|JtS{Oe6LvD8j=Os=yAaH9OJoA`!!+YZp&%tl=t?=c!_^s3#H1M!t z@I4#$4B;$Z=Kb}o&kV#6C$^iN@XXCdy;P0djn~MD!a>qJvXR`r)IhFLL%60lXIA!f z$;1!^-k%_@(at45ausOf3P)PB4sUrT7E0G)=ocNbsUd9sgr29p%!hv$3tMXgjvq2G zqaqIafmT!xw;|}J6$3g^``(To!5U|<{~ERCiyauZ#)%))ci;2>fMz_ScmMJiMUe*5 z(uvgdr(El3{p3zQxO>38GYy8~~TIk=FyRBM!2dRc+IJ=6*^>knPSG4edKeaUZs zHR$jp!+;f~+3(m5c+Q?ExlJ4~IrdS(Htg=ga~U?Y+Ga(Ci@eVQIJ4n0XWxZ!rt>5x zmTl(T%cV{{EKJ?`jRsOp=_^Yj8Zc)$K-}YkWa--gxk8^phPx62uJAQkszm)uO5|7- zs5v77|MKpt^N{|xEZ*@edDk<$YvPJH3|!58n;yhVyyM_sYXfe2Y{1$wHu&}7>2b_Y4hnO9Tkwt_tC78$ z0`U6fhVA`wWsOzIxwvkq?ctJJT_WIBoY~Zmbo9LG_+CcfR3*M%tbc;?nAem*O~)SQ z+KW}V?r{a~Vv8E-a7vJC@TI8eRj2M95U+g+R}#GYsNXJQl`{G@mP z0QoeqvD9UT<*9Vep8lqi8w*&A{o;G1;S7_LoRM(PCEL>#_}7y-({~+qRqTtSX1-sS zId7zq4v$a7q51~uhsf0@w%LGAe6Osl<4`V@IhxetHtuV~#7WHd8e)UJsf}1L^ZAQ@ zKqBvWtB(_F3exY{p7RKoCrQsZ>dpHckod8wqWzpGeOjkT&089bIix|q8_d?IPtD#Z zHBg8+HTU*CBeP33QHvi+ogB}j%#%D9EoQt>GT*!yXA$PnXMTx3^eW7VC7#*-KDB7a ziGOnMFUn%JuRH5xa?VK7&P1xjq5weF%Q$jc!B-JAm*-LH$#_8 zt@+#}ESf{@po@8X8fNB>Cr7+76U}*7RC424xP@5|M&=8z=lnHlEEk+6k9e2bv@B}V zID>n~O_MAc!Z}XNXp}=Ka)+5Roos5%U+M>Ejt1R2Q$JXhnEFTN5N1Z>RKaMJtQLbs zo-tTilR1q&^*Ftf**3432TweC`7QeG6OwS@uOw8?&BT_c%=a6S31bgx_c~{xgenv7 zcqaFvUN4Qlg+q;aF7iy=yIP^$m7FYHW+Zc#;C?yu(Ihu^BuSPzSyFAj_*jO0+CJ7D zi!`9O7Jb>< zD|dsLCw!keLF#T2UT5QbO)ojzfqK1Wq3Cj*o}@_PLY~=Z8tW~SYyFXH8$7MiiW@vMq)BsiOwGvRL7EpBRmgzbsGs zBN^92q1#J+pNAD|Ts$N8SLa-b9BDm7hZn5bPj;hDuz~}{!|KSV?=ItflD1o+ zzRPp8VSOt$7l`k3T<&8T#uCADC{W%t@%>FawzWb zj&E#8$56g6`V>V^dA0` zeWjJROR_pLuk8%`ZaaI)OAcfVV}8FjN4}Gj*f^0`rmq!t{=E7?Pgy+8C3RCnnc2wR zW?ni1r}OzU)G}dGzU<=rvb{C=2I|yO*<-~#@E1L~n@ykT|DaASlHYgZe?M<~m5j>F zlfm6WFq!#!x5xzyWIr~1ho^)wL!wAl2ux$CJFCw=j`#1K7HT=OGDrIE48^Wv1{j-J zG0u>U8w=`*W{pe6aa}EM9gCIysR#T?zw~;wd zd5t(5#=V|gsG2LoRu5SUglFSUa$Q-k z&6Q=*p*WC6j)nc;*&*3@YW0<}2I>ua^@gq^ed}B&_DFga`npT4qPg<&Z|YrtWu zeHO$*3w`#H+{{1ns4IW2=JaB4{k$c9`aZR`{Ho7+mn5QRm8(vr$e!TwTG{_l)A{?IF{Mdh{f%boD0P7+c2u0EFY6A z)3$`7wY%Yexvphq5(A#(Ek{1)$$~Lq*w3FgOlL*8ZtrpLL0!4PeY%Quq~{*yY!0(x ztdsiXNN)*#>5@-HIUm`VIgh8Us2b?NDekY0e4dIq%#D3b48W9*bspI`J&ZN<>U^n0 z-T)O?d$wc>Lv}W1p7jtV`3j9M^{rD`pYKaY(>I(8)UJ+9oRKSuA30wkpZdNtX*ff? zde8zdF;fqCS(qadPmJD+oYPctM$|Q5OI2WyS15*Tj)jqY)-qzy#s15on8H~OJwoxL zya5Bkt(fw6Hn|~hnK#NMkvSpopFj>EF&zc&WW(CcQ_Oq+NGs+qOpY-id?9mG#}MBx z;v?>VawUFdC?00<^6Y*~j5D@#v*XX-BJ=ElWSRZG6Zjo2At-48&i|BJHFMEdwiV}9`?cJ^~^XaYK7~C1OFte zWrOpl{7MVOJcR+Cb*zYZL7j4NU2*u6JAEF4E!C*YEr!iUlskC`J5{)LUb_RVU|N_8?L@2S5Ple zI&ASlSNCY@1E^~YWnMD%GRw#BlPP;tC`nBC^)vG1Ui4Sjqdv~DPoC9Rq1Qa(wXAto zf6TzjUJ7jidKrD0s~D6_ofqqmCnf0FzU{(@-NY?6s4?k$6h>4}LU=3Y&`~#6b7i9J z{N;nwv!hUdv=Nnta9%Kb!&;$cIX%W3joRqRvvLkWIqKSmu|C0Gaqd>3jyVd)Y$jZ< zO@AZxL^CsuvSyYKzPw^?+68(w-`Ej#IUfzuiQl(jPTYGvI;zd6+a&|%D%00ToZdi8 zB8;`bP4=!ysTn9xRG|$^Is#gZK zEps8pmMG);tMP9adNddR=drgVsJlXYr=n5xPubfSkHJztf7e$TXg)!q^`&kuU?j7t zD(dlJzlnDV^JSG&rE{nW+0m_Qw+ zE(XQI>CxXxk0JG>1!tN>(_D?Q9reg7L!HqS>iE)Jxb)sAGwP{PXmm8zyNF$N$Y54A zJvc3rMAcV~CxxT2lJ8^ta68^5x#01MKkt1X)OXPL8UAFS9O&+Yzzb1`szfa80dqnl7223w zK0o!jtD~dg_+vsZu7}yIMT=#|%ZD5vY@_bQtuJ%AhEey*{$@fS@Tu3r ziOS?$5bF4lAcGsI5tsP?k@nS5ZEoAQNvXTLAVrb@73wYRnyI@$fO<=N>h1=Fx+_w5 zBm#9O5U9Hms8F}lK;4VIdGBw$_r`etzB>k^=LSeZzWwdJ)?8CUaf>}v{ASjdvzc=p z7cafLyJIZpBzYT+2=b(#AbDOck+EW&=!O%EsjsbR!lla8ijC#<3OOKO$fHco3B|(Y z#H40%{f8;E4=%*Xt9vR;xl4ZB7J7nJBIdn7_jCB!_;Bi|L=ZkUUwX zkva(v_>eDLsS5Q)lWmxrLBGhj{W6^E*{5R|n)7vsFC-t3yx<$=SXp05jp_Cf zJue-LE*GL#>Otuk#TgWPpiX<}A5nyUg^>klt}@A*01x^*g`rt7os=)Miz%_Fyo;f4Ps5$GTVkx6&2cluNY)~ zt{PT7^-Y}rG%rYpofz5hs5qJ3Mumn)nRg#e-$@7Zb#4~IG(AS1Tp?!pA(Wm3MqItl z-0-sGrPhj-Pj^(<8L!7k^64h=zSFUf8;Kaf3=PJfPw{g8gt~6Bf@Q1{tl;9#+T62G(%JaE5t7)Ei%cCi8d6SaJw#(0@%r_b+cdgHk> zpM4$kqsjBF&gZZCh~9b~!mvz5e-cmTCX`lah2f(|MMBM7Phst=`zl@%8JaS zj6^3(?-LK&wSU~xGUU=BU!6W7sr-W9mY~RimWFk&`+lrZKY68YMAF{THp{{y|0ZR2 z?$mZ+>4la{chW5<%O7a}`+lb7Rmpef7Jo06{A%?|%hWf;+OIoO#Ztfh#-zc2KUm(T zeYGTJQ4gN+xlmN9yNBvC_Y%S!(jWd%{eG@imNcal1(t%r?>5 zFJ9(vBF}v&XWT6ea_4Kj^b6tr_KBXiX|a;aGcv3~jASmOuj3wrgwHU@h2us!aw=AK z4Pd5V1*44Js(~x_otE@ozQ0P1>NPa5s>v(u;|b$-dNG1oRg1}AoK6qj0&)|ZF)z@E zKD#`7gD>#Dvk^}Y^}r5#&i-^DC$T3rke|s}+(E8>kOpDA*Ivz`=MMdOKKCV$UZ+8E z-mk73=-*g^{Kg~9oPOeo(YrMG_a*C*iD3xYM2zaCo_;&@RxQnWGS4vYXg!oa>A_k{ z56`#s*m2h5dL=!1P+|B`QIE98p%``{47pBv{HPR;0w-o{kdHW}kshNr5Z_+FS@xVz z>X<{}QH)skV?D8ya9mkOjc8C9HZRko25X*g#ODv3U}m*T7&>@x?;yT%^ST)a!p(4d zVZ@dx^u$?WgnLC3f->n}y~u=RW+RrW%}8#@d_m$M9fQqCy~_;hIVQa6!;Jb?oMZ3e ztebVytyAPEcIWrFm!CXkLNb5eV;p&rZTWN2FdMa zJLGJJS8xVgezKO@OFwESa<13fP^ToZvAdifbH+62cLq*rZOG^S`I~!2-y@muq24yV zQwElBj^K1L6X%Jcg^&~JXkjhFb8;7Js@x|wL=WNInvXp%%lxGZ8HnD*z3VyokvmvZ z9LM0BBxk<&FUZQE`D)mF0C6l_Q0VDaCu25Pk71)zh zAf1_wd#*hF;(8Uxp03njO)8Z1NCozT$vRZ4+eBc7}*tHgjE z`O^MWp#-&~4y%O%*NZ6VZBiiL+9?sapIj~CyKWu|45`g|0X1K7#h5MkvOvP=Be!t4 z0xlgDSeVRNxFa9S^hdAdoTvJ-54_`t=;QwA97K(qRfnvjoN+42XWUG0w-|q%=|dkl z_BRQC{INw9z?>R?be}=aRDVCr*~koP3-h9O2H@&hdi4i0Yub%IK^4i%Ivm zB(f?;VZplyc+RGGTr&Ib<@|m2&)p;nKb^?m>JovVYEg)p!nr_s>gHfS%Ck4sxh`Fz^qRmX^)jp@*t~q%S3hEe_=3wYVJF*IyO^{75h%7!y?6uez8;Jew z$;P&HJNl_|FqgmAOr4Fy_u07cm)|>J$H<%6a8YQ888?y=i7J^tL@jfBc*&DdF5;nV zD$}nulzVr`<#lA%GqyM4xYkvAK2u2;^P{sb zxXSiYE^;ujsjOVtyB60=_9OY=R%bM`2(ZXENw{wz!%~H-#c%Rze7Krct0ttRnAk7x$$+cev^671% zY+R?rpjQPlQO6m}LIr%26fh1fkhj|un8^D{(JKJIj|bojHHyXW1fXP)4v8ZIunGQ{ z)WaVmeRU|Z${(di^06w+i{WF>#s@H;YQTRzr2_Wp;8fEe1AY8apSa1tXsC%45k5vc0wuKoh`NUm`p%m6(ZnQQUKE!et z^Pcf^j70mR?B82a%Q-I!x!%MQiQ76|CGVwuB(|O>wo;ECB=4Ca7DR5tFlJJmBj5L1 zB!c<%dltP=|D_jWF>-{5ko!0-5|~KbqFogJ)pHg(h@Kb;^ustyj$=pac!hlAIlMP} z@G;_S6UV0_ZFwqZ_SDZSQ&Hj*^CE~*g_Y)7C!ggYJx+=f8$7s>-Xd8ks8cQ#7fX`I zQDBAFJuA|WrDDl3em~g?3`s>XM=P@GlNZyQcwZmR@Q4?UqjtDFRgJeUrC>kr%@>^U z%_dIh#~Iek7vxTsOu>NVydP&Udn}F`R~z{Wej;`{!lOS?&Rms-{>m}&WQ`&V1ij+kUB*PK%0J9w>E58%8Baz$vq|Z)TJODe*F@NP^7R zL~S4Ivo<<{3k`BFMT z6v1Zc??G=ybDUgQl|W6QS&lle2G5U`lw)yHE1&wYal{bz#))6E1euyn-^L|IF(eq} z#G_c^!5;X1fwMASdTwX4_B%k#!jCzjuQ)TSqDDg(HOhFaVCVOoXAyU?s8D988eKkX zQ0uxH<)^ARYw#eqUWIol)VP$T7Z&k{rQV!L{_6?#W;N1RYjAIYhWvOH&M)NGIt_*| z_QVS(4f)GnC{@oB&8efw=f6eRPt3YY53eSAYW_lq(Xt*SmSml$M|0MSk(a^{Uzc8r zC8>3ZptmAtW-ZOk#&qC(@jP`e)Wa?2?`rt-M_ZB4Q#Kquy_g+f3q@;U7FUUfseA7odJO#(isZa-M6rKs!yY|hZzz604#V!_Cd}qc?#BZI?rtNl#G0>1 zJiWDJsdX)5hUJVArnZ->n=tab5iz&e*A6$L z*gkqTR$?zj+-dC{YU}=`pUYPxvNjp9ygB`*nv)+nlyk^56MDKB@w^E2q`Qqc#@C8g z5V!Fom*#l}ihpI6W(@N*I?&IXe8fT9nQM1A16NqvZ8*p}l0BbYn}KJgGBJ;jB@Sjy zxSM&hi!*U>mJJQtW?L9J; zO8zF^V585soqWg5w*SLt-0a*~jO&=qo8~SjS81dLxrDbk<8mpjM4dnd`h_SkG`CR7 zv;OjV!hGfUK=ip5fQ~f>p@w@9o@WN)^^QP#Ek-eOjeB1<{TYc@7v&87YjbkOf3k*{ zlL~X6RP_48nNLHW@sEi?tFlpPbq>;3@=WHLedjzq2z+x8V!-(5AZsJ#&Gp_?-*ftO=Ytzeja}=fy zi^AzGQLHVZi0yF?e@AZl0oE3$xi8jC!>7Ymq`9Y}OdWbhbKiUXhV!)6InWXxkFC!7 zU<|!vQ=7={d~eBcQAuU;2m5qU%dbh!@^Fw6qcZYjB+c)_1$3la0fH@XigMbex!chF%@q(gEM8Ok~dFo$PLy@ zZp5rFvhKJ{PB?3tiX(C`s0DMdi+{j^>OSK8Q6nF}X{0SPqQ(V#${CeLes@>k&3yVM zFIJ-G>LLh_D3BV{ieT!RKosrG45l9e7)Rf&J1qmLsU_d?F}GPAi|I3jW zVdB|$i}hS1aveNVvF>atM&$5JnMG`UI{Az5=-XS!4AB?ai1sEnpFv-TJB{RLq?`13 z>LtUkwve%op0fD8r#M|Jlol=M5lIe)jl7U~2@d$#NP#Eefmp2%z*yG4l{N-plR5x< z4+SEgHR;qR}>o(*xF;ompQx(kpuu`LCVG zCvqc4h1crUJDxRDG;-sim+T+wAvagK$>c98@%Y(ThO$R+%2#5=a|Jy0N(9@K7`Z@+ zedhw;dy*bkr-JZrgMs+HjC0pgIyB}CF?eefZgLGZ=@x}gzLBV#5QT}0Q_+eX&*o23 zQH`I?kiltqTa7jHnrz%F!+a|>J&ZX=IY*w;zJ2sTsbP}S^slSkJYKrHnWe}JgD8nB z)NHQ7OYXUqlF2vk>`6~?Z)huM;8Cc@r!aE9bII=xq`%dgaEvO#d;;!48@c}^wlHJk zUV6!%p#SR*;)Ud2Eb+?3(mBLsT4!Jy@A)@xnHfxuUeoWy@5wV5--~ksYM8qbFMaCD z*KZgv-Dby&+Se#W4;UppJ6^u`@Pvzn8phsU_@HfsSqGTy+){;RzTtQr9ge5d=}WXZ z47Q%kRcN4xGkf973rz5{(l?3yZ{9ENncPD|8*p#)WiLBC6E*nWTK6M2C5=5Vu`|m) zg|;Ozx^;D#14AtN^Ct2vi_mLur&)%O>lx&nAg3-fM`gZID!G$S5TM57isa&_d&2RB z26r4aP;k$mF+Utb?$MudgC5mdhocwqg~1cZIX`T~fy4A1{A0$)T4wzIX@cuaa=giL zSe9%eU{ds5;=S9vhXO=ftz%B1gVG2Uc;@I5yvx`zE&PX!*tDbe7p0?B_BNdKHC>l1Vc z$_qpTatOmz1IhUgfIf^l*!huoKA(QIwWCm)=hjYs9Un|T_=~9+$^E$wJz=*vq+v`m z_RSxdJAEM=<#qHPd`0aM_v&@5(OnGmM!f7Tt6dsN`R<;Qo9-gF?l+Pa``zVNav?PW zg>s&}y{*JsYSmKWN^qgPcMHVgvjOO_mp+j{1IRZB!1!-|2qu3qn`hX-B=$8AqwuXN z_vg`(_|lJ`N8eQJV6W2UBE6!7y+tQ#1#0AA$TRu@mB_&xZ4Npf&&J*y?$0;9#rGd? z=|JDXUF4shF=_-c9#UMVL^tls-oJ`qNi6Xn_LnJ}c%~KT;CxSqokN1Km^m5?%LQV^ zd1mPqaDV2$+&zLGSpB0ghv)s1_B`kRNuw4a6;D}fj6KY=b!{r1g;FC{B?nH$$Z2ew zgUs2?YPe1=!`2)u+TkWk70fJ&R*U=TmXi8jEnA`+OVfJPz}};`r?V0{(F*n}_MeYf_gthl;0^1bH<1`$k3Nn4s9|7^;r#h&DF4}t z3*-$hKE$=t-imp|7OL>P>P9`+RweTodA^srN1vWI?oyn7qvsxLuY)J49F7}vn4#R?4DD9xg*aClUDCwb-G~Xb=v&@|Gmd}^?(fX5QDtHa@Aq=2 zcy3*%pK!WDTScMNR^b01Xj5plKFqsHV}@J%1bLz2?0W-q)h@?M%~PK6{pbbL4-Jm5 zrLS-=HBPZ7+HR+}-^y?_Js6HL)55Xwsh%3GP_)sR(T_F!tSCp5w33mgHV-exT51D(GMG*eEmim}JfugE+NJ zkP2Fp40BAB>YTl-9m7^)g}onF;rOnK;V5@KPzIR!LstPx`~y z=kmRHDYQ4mET={qC03mv_iM7B{F@+q=v{JcswY;jQ)3%zjQ{xQbUo*V=XaThy<3mh zoB8_MaBNA}qtO68h6L-OElscEh2#??^56dSJa#2F|GW`8>J?s%rY65`1}5`bMO@`s z+9Lzy3KZHi{izM$Os(2)h4upYUZ_`C<(w$9=O&1aJp3B34$02*N9em^mbXhe)7Ywk z!yZr6W&U;5ZJak$_C!zmA3o0x$DT{{_3RXmHYs6vG?jCKWeFH&qeg8IeT6H~55FOM zDb0)5+Gx6mJXI2w3@u?_#p1qv)9#m-0l~!t>-BoDSJTLx|hq}DKNhTCE zN~uZ)sYUPOErsOfIvtg-56G!3O+IC|28E$qKV!JQ*OJdjzUP{~dh9tBjyj*{H~%qGfhmu5=vABy?rK?Htw3ayAAXl$Uh~ov zRJp*6nf2snaew-@$PX2_MbN7(1*eFImKx(MEx5POZb>cv03uV)yIBHXxNutVlN01`l~UT!D=| zLzeS>J{(AV%EgX1Yn-I*0rCVhh~XLNOE@qEUnbd6ceArJwB*b7mCRb%#Qx}3GL8~| z`eRVZ+A9U(bV7$p{`7@>k&MgF?1)WkC})}#%8-tJ*cVJZk9+;|p4rH{;wm0B@}2k$f@k;|EtoVB>b;V?4tx$JEk$PJwu{XRDVLfuY>5cl@+t zS`X$?5mPPmi~a*e$WsgEURg66_~9nIcI8UYYJW^1Ca)*IugMDHUi%%T)~Et;-RO^w zha!;MGX*EF65l%GD7g&^#Iw9VYVV9hpY6%04r0+c&N8nUan`QPWuDLHaZJU^q-=cV z9A)>_LMhXbe91HH&6-jd$mYqeB5n5nmeXASTPrhndlGrRSL|qhl-?b|3iKJl=h+g8Rijfdmd`U`XFX}_ zu0ZE%0qDTl$FpDbqYTVOlG0616Kj}e^@Fu8d-j$on3qJ{GT%wcJ^w37vzXDw%K_li(Pw|ko4e4unnfINJJl4CsFV53nuajE5evrp^Mh6Xfb|a@# z|H%8R{WZQW^Mbd`q^^|f(~}r-cVenp)f>vhx%6Fq=7+QVyYlia&i{I$9gNZ-bw z2(BM^VOEop`wsGvStpl?_K=FFa^-}L z-UhtB=a!M5ILD4Y+tl)UwE`^~_~YtrUSH0JN=Mk~tL`R!p5;nwXXc5M4`^A=nUgE| zq?;ScB=Qq`^weR~NaF9im=Au|j<)uOGN&E0rB?c*WK+(%dXpbIJR9}-J{K*_7w6Od zDC9n)Ab#-vAFkWs&QfGqzC12Uo-#iluOn9U@67eNTO&1Z{FO6#0r)YO{KslmG~)g+ zk~0_&)?0Hc1`!93fZb%p=o!p+-t8_1KLwU8VxE+qx>;x9U26Jux~Qe+pWpI?`^=`> zynpA?>tii-j_eJ(uP^_$-*2Dhr;k@n$Ys9Ha_7#K3 ztJU(p-WGtr?vZ%l!#aDmow^3{XVZSm^l%-@_KC!uF{~*=ImbHQP$m?ie}#^9a|vcl zJWWCMlkaijzLTVJKM$#@L+GRkD0u(=-9_Fm_p1ea^TgGK{<$l;Z*W~XwaUiB9o3}& z^gNl)^TMwTXNmsw9Z9z1rK_`;PvlGT2|x7Yb+1{8vj(Fb`-zKht*6FYtsc2kr~{vz zj@{(%RA#N_9z@?pdLjL~WW+`f8;W-#Kjnx~dR|c@@=z!qk1h8Rg8FT%-*zHjx(znj7tI(a~zn3EpPk&F6XDm;F6) z>#Ns|_`#n)w7U>psu|_^UKOg>qvmA2i8X-@{ofbjT5h}y>O%iJCG#P&jo4b7xrpqS z>qZ;p_YW1m(#P$786#G&q9(5@`EF&*vaYd)wH|$-4jQ0{r*|{|t}YMgldx3<-^t7u zE>A82aoWFC6xy0K<0ZJVJI)*mLz5BY6&AB$?~+39Pciagg&Hr&wWvbwLFXd$E1aRw z-YsvIn5QcI`)XXa>cx8Y$WK0Y*7j`(?CvorY= zHI3*}k=c-}O?33?ioB{qy(4;<8yRuJi+Qg-iPQMdSCLtuUA8k<+Qo!9rRmSe8gIa% zIMMXuyum#bwTKCo_{Qhisn8z1YLuK;9`qlfKV44~yj?P|cep}ppx0N>EDb&7=z&#_ z{0Z=V?jnzAkU>;;HTVoYdc8E_MQ0ljtI+0LjTgs24X(M+FDrz4%;`2%n6J=w@`#o3 zMm4?OsAo+vQP;`b3u0cf%^<%A(a(!BfZY8?=7=!&i0f_X<5+1sONDBwp~Nrg7kSsl z+&6`G-jX;u=B`H0Aw71tB>phZMjlup+N_I{p=(sQdM^wkZjo1VEFHIby`Jo+&tNYP zOfrR`Kur&Xem1;f-P?uv-Kj2WoZJ?Q6+3x-HDod}Ka?nHVo#Rr zP}H{?;Xj%A6}-N$Ud2g|95q5JQ1g7(fNM$V7}1aZm0|Hxa=Qv2t1_Qs81sTB+we|R z$V?rh1e9Y|*E#Zt`x`OQNPcKHg?4h(L3#g7gV;CpDC@>`m~VsQ;X;H~HA#`<9?;d& zGaH9<4;A?=e7w7o`Px|;9QqiFuFDK?IFOFfj|wrcb(|C|Rbd7_%hJ3#JK?&Geo%;% zvIe=gjq9YE9+PU3Z+OUt&ZBs}Hphs9pU;3PeQu8jS7QX zHTs3zRkwaVPYk5jfzi0Z8Zb-*SvqD>& zJmp@zFBbFu-B-?tgtqBWu2pDL+Q&)mN_SM@{BW8umpq0%cRo+j)L2~ zZ5D~s?y|NFoH_y7ODkN@X){?o&itZ>w_XXcRP;*Z*#dswZvZ`XTElO8P} zYzh57(=zvdmc?~a(WJ`bu3G{>lubVAYDx-qyl2_G(K-33_ZZ9WTJ@6(XWuwib;vi% z-i5W3o9$a^30N|@UHjoz&Mh45ncPP4ASu0xi?4B6>E!YAuO`*bOHFbg{l<5G>14~S z8aLWaDs{lpsq6iA8?}$xecKt)cEPmyN$u1JrQVr1v6qh%YncS;PCw78+l+FZzPz7S zbFZpNPaK}XYk!%=K&@fBVhK{Kkx_Q7iIduk<3*WA-^N)+ImSLYooC&fI|pP(<3tJI zSNnO1@^BZ=#Y6EjXG4O_jxo!nA;j$I^*G;&{KX-0vi)t0TpDbWeu42)zp+^~$J8h~ zg#L+r)mYJAjeoxJnsJ{VOz)hu7;+c`IB#yEf~krp7S~YYS|@rmJM+Bf+Sxr=gPQ@K z2(QD;D4t~wS!$e5BbR-p7hYFqhJ8m3vf8LICWABWVDcUtY2bL4`hK31Ku8|3E#whU;O<4a1v<lsbCP*l#OpXw}f6zl3ynR~O&MxSVE5YoDbBj!B6Pp)Ko zR0y2=vaVRIM|s{K$1^w&XFXw9Ms35IFk=7AyXt9%x}+JWw{d3i%79=eBkJ5Y0{7|1 zV=>}cX){v3(5K-N@rJcVYju^u z^L)sU_9Q;^%LWDa(o@+se9>~x_NQOLpbWU~vf)#4W)N}~@|ZQ(d18SBLb>OL^R-Xg zaE9mQ^gHPozs6m@-Kj55UmD5|@)SQf&@Y`{is3gJ$c=!8@;*f^I?hGCiQ{hjsh0kw zG&0WWCJwupqu{KPvjbg4rFWC&gWcuJS0@=z%U!1RZYnb}ykvWbhYZ}R5sPnqIr~e+ zTy>31e(NkgI#*dX&`qva^pJ?3ZZha!Z>d|!T{e2Ti>?E8_tV(7A5>uA_X5$9J5_zO z67!E1NHq0{f$UiW{>_t5{h8lqQ{W(d;6{I^-fDBcoFK>X=hs5&!I=BgT7g#NKknu8 zWy%A0>!w`%GZZFpC}ww{-M5)M51jKlYvh*j$F5^ko7t z@xDJQ(i`%LU59SZ{qePv|9>+UmdDZOKQ971`bUt`{4{K7i(tvKOnMb&?p=dhjHutf43?@$}N+loG`tvLUQ`4!DmFzb>P!M^lt zuv+2T^FLZ%D<1IYeJ1i}W)o8%$hpHqYG;YFzwE^4X5W33y{pp~D-NVs@wOg4=k}#w z@zM7%_-2y}%o+OGY|NQOjuiX7C8e|J18B#&-^`TWVn@?+w1EGMRUio~g<+8KI2z!GN`OtRx!7_L3=N`w5qXGEblGnD=F}>nF2Sz zEAaM>0**Tir0$%*61+@-wT+e7T1J6cp9*9Bg!JVJr)g#}`q zp@1`ajvC&NjyDRWdq|-qR^vRdJ#~8X3MKA3`Nqt9ubjpEuS&k`KFRy}R-Po-^Cdb$ ziP3G8^gSZ)WE}5T-vKb%IQ#kHk2+O|S;p!x{-Zy3b~&? zPwADhjeR}u=|1IyQ2H9Rw#@7BAMB5A)%-EBg$~a(QK++v_fiRBbec#c6LWn;PU7xq zk+{v7STO%BX(ApJAA#MR)%E!riH4UWVRR(tmzmO010qmkCUZo1zYQzOEH4}H6%~1l zYa&rSm-o^d`h}d0L`yGnA-7XcS}_W7p;6fOAOiESh8BZmnr7jhRV(5eRAq9q}R(zO9&cy<9Lk1CdZD2)( ztQ553{WX+0NP0NAj)I{S0SpT>H1L(07XXXhAuC?aXGT zfgQiPk~{3f3>p5+gErK@&(6jMVqi5}GIx*P58s%L9a(m?Yfc=hLJsyvlK)8l$qBn1 z*H=Ir!Dv9 zb+jBf*V{5`z{8}7iF!+efqN`qCbdsWgk?(ChL%MG2V1ghu4tF{B;2>iF^Be}H`YlW z(Wy_8IV?Hp_T5ds?+X|CuAd)dIsGP1njbaDi!%nP*wP@;l?`&-iJBqiTAW;DmVx!+ zWn^5ONNei5tZ}kDI8HkDh>_l3j8cW%k$rdR|2^Qa+_@hw#i*e&*vJJCer@8s&>Sxx zse6e$$t>%6hov<=t5y(4X>W>?=+~?%H^)l1k#RE1Y?f)WV@0Ph%0I>F5A|7%rhPe| z@>C(>g9pylW(G9pFoW6uoS}EO=`FpzEgI;rs*%B(FIc6);acoz{;JTYf(k3^YH**= zQSF)ng+j%lK^mEwP3%~ zk(#?)4=gRO$IL~cC`E0G-_kH*M|!*n(Bsb)au&ncJFq5vOV91ap<&E+rFKk74&#?F z1kR!N*SRo!ZonF^nH~$W*iSE@wvznENp_wqTqum(MHlA1gIOsU@N(e@B8cxb@l14c+y8`d~*4%pjE8 zDV2fxS=11&q^CA}-6cQi)%}!M-!$SZ-!rgciVdy{_}IV<_>^UDZcB$tKW26uWNyJG z`YS%pU_LHA9A8m)xygnxA2YCYE-{Y1%m=y2OzPz}-kan{*5~(zWFUJgGvUf-&^y`2 zx$*zyGakL{BQNT!#qEbXeM3Fu>@2l7_WtA2_akQq^! zbu|*>8q*^;)rwc#OD~p5LyvB(NxCzWvbzr*z!{tJ0U!w@l_awiPy#AUk74UWsK(8e_taTZPhG*yv z92|g8JkyMO=xuO@`+saCo)X6{)`;2@)_23tSgC2X;zw306x^d-e$yW%jx)tU*%+9e zjWU_pc=3_G(3v^NYr(qbHu;o2RgwbwR|YY=>kH>_7AG0RGkVfpp8F#e82OBTTLA^K zVxWTOFMW%52BOZLAT&)5!k#|N$mDgakrIg$)uYg93$NGaDEv6UET%dCGmom)HkCPy z)R+ur7B_3Of@-O#V$8AVoU*(U$w&!x?(arWXEuSonXrjUib^WH&VxuabLH)z$1(yE5xz0Qrj#>BmS+xbkv^Hi{UP z=CnfF`7!x$^sMyQYLM6TwkkrL#IV3D3(22ff1009H7|5~LEph@o>=SWiI#qPC|>JP zSY!ROK_tnfjWM0KA zPek~5VZkM4G7Z$=K!_fblgMKXrO%cv9Cya?Ji9?I|7e~!!~wrfH_;1#9E`8Lepkpp zeN8?)_v5Hm%rLD=E(rCD=SNZVK8rkutMt?)XE2D|hw_W53I7l8^FxB{f0ZcL^3C#W zMFO)J%`%KQ)9Fdfl;L$coJOyPdHm|5Mmyp(nbZhW+0XUUD;%5oxhzod+T}Cz`L_w` z^=33{VaBy1X6R0s@Gzfv;R9wy{3RE@+5>#!`uV;h10P0`LrBg=eNUzKgO%CN^_ALy zvPx~YNWMqM1bO@Os1%$c1{PwLmzz1iaWTr@Ku@d>@}LSRZ8uhdDNeCcJpEp=PrX4+D!vFPw{Cg7h@XB-ilr_)=rP%3XNp4dt+%+$pOKk z%z;xY(fg+obG7{M?$k{#(-E`L;gn|(ZciaU?i0Dx4+HRc4)5*Zc@ShA=;92A91b)vCT%^sS)^|^E_JwBL)r%1&?ixnGqcG~-pmyu3= z5OVOI=h^4d*+{78DvPIj$koyFLg@W*h7D0kKLSk3XY9rNCQ_H7}QKwyEc`a5MoY+ZgQ-E znT9!$dh6w5v&ekJ$uaXW&$erjL#q<0QeU3Lp;nk@q zjN$pUXhkIU?y#b~iQJDZsW|%6iovI?xcbS8P*-|7HK%vwPLH(b|c;}+LT zpTRlsn!~P+GsJNEA7;+r5cSfWA?nv}J$oJzDO|ByQ-qZ9Cis8AQkc!E5 z=rL@!VtbKP9NR{ZtcD*@dqp;?Y@zSyRn}#%$&r~szt0ATWu(J@GP3B0!d|BC63$7iy}eXizki{VN2CXJMXC3~T$#1;+_UfA-M3CE_Rdn z&c5_4Ayw_Z=S@JJc)fW4{D+(g7q34<5#z~q1baI z41EjflQ4@tCHudr!Fs&jO>dP=37AM+|LH3emc~*iu#eX(kZUHw27@1YohEV-NpdK4arQ&Qhyi zo@^uUsqr87O(4dzow!L?cX>KqiPPkNIj)Mtk+M_FpgZhQQdkblUxB5qc^gcS}I$#rh&DO-={OZl4v&{rFQYQ6bB z8!@Bfa|8OU1a;Dn_+gOPSwb){dw}>upf>TL?G*P3ijP0-gB~n^d*jH z9>&_A_;pEd;>QQL=OjAG$))*%lm2K|ClU!CQ_%S*aaT)2*+%?w%d-Jk{Wt<$E|Ir* z&5jq9-K6J)ztY4q0GDes7p1xtj zNH#hIHEEYdk~eYZE%n5w8hz7F4#32Z5x7#8dAN_W;Wo`#T9wO{ zem=~h-cHZul2#m^la1jwoTXrHf!wU^k79F}vrK$EQe#I0jk^q_-{q4h{uuc+0?*S@ zP-G$Vo!y*ee4RYm@210YK7Tjz8PjWI<4FhpUG(XDyibRp0nD0to{V#&=+pPpMKS{N z#gCfuo4+IQxses-PIjbhbCjds3grH8e~i5nfp>%XIk&N6#4=C0YgS^)cYj#&Bk=FW z6lC_Y9B+TZl$lKAbuQu>z>z>`Gb_0aD$lz^ks-OThT*7EO48PtlXI^10!_g8PYeC z8tm{F%quVICgoQu(2YKogQ{^}u{s4)-`erVNh3~irO0>VdS20#ewU9@kiojbaJ!CddsHYBI?>Z0jJW$m z^0JMrS?{>W^uR*V*6>Hww&V{wSh;7=SNw;gENa5s^V&Lcu_DnW*NS#VJLZ)luaI^9 z1b#lN!XuEVPr-~n)Db2%7R8=I89RwHglMkMt10+EUf$0MUNUNIp*+j*C$~HTfBzx> z^bdV0`n$=SdIgfaioDK4QE+-q9xijds{=@$+B%+)3IO=1S^8e@uQBfw?`1ueT;&n>qDQZqeuTtUuHbn0L>= zclH1~bSE2%qPqf1dgw5Kyh3##GtbuXe!O2#bUq5Wdg|c$obv-G&dE;MQN5;G?yV}2 zuqFXm@rd5>#uV0=%t6vSOFsR=r(ENH-b3|BrOLrbChk*H0(T>|&T(mRDc=w=mCc3O&6IoENgksm;%=_GdS78>+yq zTl9KaP4D_HDLAo+xKB4{aa)-y%Z&cGk;8hs3-_@QJH92x%gg&7&8Xd?YXj~rp+1pk>RrPDdDg)LPOM?PrjkFEM?P0> zAj35ps}ktyXhC^snE8VXArON9=P0?J$XG7LdIkusUd5DP5Z@OPla<^ zsA0WhK*b^%I6!{T+ac7PZgR%}XZk#@GNQ^{@{A@cw9CV&M?Iy&v*lrUoomFK$#~hqeBK^o$)o&bz*1rqL>ipaeGjsC-d-)dBLb49s+}9vtB=5`?g2=5Vq>&GGEr|8beWPq2tHvZ^H@;iB zPLk76E3^;>YH!qCyr|(P*1y__PPc6+R)U}NK$Fz0uf}>u;ykmB7}=g)?uQCd|2=c4 zJ2Q)FZWy}rb(4v2Z+u#aj#HR#zJR*UhG9^&HzKEv4dx!yt&)$aD$V=|K7V;1BUAEAflX#3z0;2mJew7}>Z{!#to+bS_4Yh>qM07p~98%x*oY!tpZnXLMoCZynb0 zKMK)gG}oIO^~{gL&}yj>f9&ZW`9>*)z<1a_sv)Rn&QZH+Q{ojVj& zLNR?2=L*H?nZ=s_H~C_Vl6YOX9^QW?kMaolVhZ~1xyQ)zcnzBMVJ-c|h=-$yd37LP zue?z@{-ef3^6bVwGoZx|a!!^O;`Z`5*%+us80RqeI~#FwD19wgv&ZNaBSWitAn!8y zXk5?JyvZXADa6H-anikk2QG9E#ZBT!^@ux;(kisgTOE*q!zwJ;5<<^p1OBWe|1^R= zkM!tRy;%kC3Sn65U_$W*HgqMQv{Ei}isRMD%v*#VW$5!*H{-v)iVNILvSbwbxoyaM z9d1Bi8FF8EKmJ-BBZECu*mpGq*MHG>FO9rQ;&x}M#z;Tb@H?GC@pOfWeGNVJ=P(Cc zZIIIR^_cb{4E4i|_&Ujkn_P$36eI7rUyYlmN2Np~Vqeo&v;i|o%F=5tkeLHXA-G8l z(OQ)ET~pq_;jyx9nmcMM^{CGK>py%<2Yx<%|22p&`N-2-Gk4a(h)lkp?MmKXH%(Hy zCHZ%G^o!JyuRV=DNm?P6{EC;`b^!qqpi0XbuiQzs_b7B|{aKD=7VZ)r=h0u~eUgId&5BH@! z?&tPB%$*;~znA>SQoHEad4&2rtr6-S?3-usb1QpL^kvj262uI*E7ZK7O~<8H|I>&4 z|L_?vt+-;jnKIQfc%8{|WLULitNp6wg#W~3-!rw7CzKDjDCv#!-KSY{)RC1*rjmV< z%M{z&Zgr}_L_t55~qh2*HYar{# zxv!3k=(qeaUiy3@){@3GNbg1S;zXIlIrgX@M#;{LmyPs39YDT(trN^TNHI#QW&gqO z4Kk7(--BMvp_*%u-kf#dApH_J>!`AsJXmO8GSRzn! z)L;!W*s0fyCGT;H3Qhkq&w8^4ZxTG|lgxdIXXNTEHO7&znB_t3#Tw3(SA^oyE8aGx~r;a30_Yw$oR}$*333V@$JJ0uxJMJHFe>kJ3Kq*c3-fOM-&iPE# z3Fqgk=rE)$eeR`nIKg>Df6hkq!tb-0zw+}vCsO|^9|Mnv(MYSr=L_$lt<*6dpVpxU zzyCi8^gfr=p;l>f8OJc65lBX?&dA;v_WD&|-nSmLmYW82n?ZKYegpRWHlXP_BT6Y! z&~i7qizf}3`G~zwBMtDsZ$yEI0S%jx={SWQ)y2pKh@vlQtGV**VC$hT|w_8?OBN z9#%YR%2@~3-M##N>e-xSSEuLs6aA3h?Gtftvc7I{J)$7 zjPjIt7qZh6yrc`WLUEjXzU^E`+E*i2e!Nl=;+fl9rjm;5eC6#xH+k}Jec2l9DJQgn za;QW@dHXgt-#O`3KTwDAeu?}GM8uG=7)aE z zEKdrI1roSKf%OgZ#I2S?x^~DHPtM=tYUfEYFNZv1-aopF6L!7Im*f@&Vn3{bhbq58dfo>_DC)v++}x@Xxjj$F2wA&~E3PoaCN>^7Bbw(lbsw_#uhQG-#;@m}yGrKKKTkPF*ha6^BeEl|G6Ty$U%=0$l`~`Z z=}dg{&qVCA40;bU5J2zb$jTXb_L&_evD9-qn{l7ITBSYwyJP5kJZpw|12cZ~Kh+*& zL)VAY`JUTwmgoFQEA2Q$w!zP9cC5H*LtHts7m9GEbIA^U4)rUw9Xh2Qqt4LJSUd-# z$C4rUjQO)(Ir#RNU(<?cE+u{+zEp5dMKr1L*sQoL7?e5<6A_i8us zt>q)%_5L#Bi@!{o9w_mRJS6xYy}};8()U$>#EobmBMy?upjAo!R3GW!>LI=}d?Y57 zx#UUiQoBfiO!oAZja7ZcLe^?*M|x1;A|K{@%B6i?a;!MB#q<_-slYz>Qwof#l`qz; zJh?S0k360{c|omFJ+MHY^v##pGk>J^JbwOEz8rh4Krwxu1h^N-)Y1j==xUyf>+g&q z-ef&>qKD*?f>~0Bm`^!mvr571jlM|gIjfc{FgG?|;^>KNUx_@%GRYQdFkI1+7pTDo6Z_3RXmBi7L+`y7z4p_8 zm`ML3d)gPz2}j#G8r0gXK}?GXJP4&0xGW4u$AshiIt^~E4#$kb&Od^ATV|QPsI&6S{zk)|vO?5osT+7*VwQFry$fadv8U`( zQ|YmgxWvQtPUHmGf5KXXjLA zOiky#lS{_qznM7B@7et?wV`~@s{T;pJw-O!olK~2u?N1k8R1UszgWfZ$6uSwHN$_G z4L9qP1$NCwz8v+fs?7cd*%7;g8S+x}FlssDx=($D8glS#8%ExwZ`fo*iIbdvWiao} z`=$C*cD;YGV{cFnoJ{09PPE~3v>jK-MR}6Xx#o82>by^jWY{qHBsIwoHdt!g(U^M6 z_x-$=`L%(<8SE3ysNO$+T4OCCF7@Ep{|D6wUD?mWZJhRw{Q zF)LN;`F>ecja-uz?78Bed{U!CncOBtV#(1M%=utypH$IUlVwO5qr47grY@Otx@(D2 zu1>Oi3m}WJOrjW=b-YCOw_mvg2`y!mdq|R>O_i8(*B9C;%!2k*BIZ4{0~OhdJIK<` z_d%U}&W0Yahmze3Pk6p*)Lx0nhm~+y#xry(bF^oenboLJ`Kk(?Dv+r(%nwhl`r^<= zC02A|mZl3kKDRR87pOv#54)(_G4pjtiGJ1Sot(tH~3A;Ov5#g9DCj@KdbP85pw;8~`U4l$lOyeP!k zRY)|_$${@QpL@LK6&+_0n^Njqwb`58gemeA8z`bP&9eKX< zkWw%Y9(_5#=oQ*^--1pHxySrq zLA5w~8)N8?9Av?+a#l<}VZo}m79>);nzYM;m0hgx&~e{M%^~Z#1snGMKR@Fza<@yZ z36Qlr{N!VyK$*3+k$fAi zvWmXJ!YE)#iLa`iaJ z-|&<7eGB&3f#MX{Sb~^a2;JFO-iHT> zn~O@C_ap;x5j`M{%vc%BpNHDKDbF{f)Owo$Mnw;yFV&Ib2(_xepzq$A)$p z=s$?uuM3&*pw|AgtC<{xOcWZ!jLJ4U4#t0gzGM!%3?%!@jqBAqA6bx7UtB->NKG)PEu@&~D-7Ju)DlJnSqG}#aO70e6AF$W#W zKFkU_Xn3aX|D9*w+4*=*NBW1 z>e(}_cs?W>HQtgZ`;|SJ8a}H+$-2s5kSJC_6&928zsj@9Q zRjf(L;;v7YzmX}@mHx%@lbElhrvJJP*R5yls~GK%+dJs@Y)>zvf_eJN)CcItSp1P1 z!6A0%oHMe|)rcw6>BVTtUgf|P%op|$WpQ@Uls{82pS>IC>uznu*hTcCggdDxlKs`2 zy~=88mi6XS&om~Z}B)RC4BH9eUC=X74*%}KVzFp76R9~0Gadzu;A`eX0G}E4Cd>zmip|bB?`4ab>qfoQ)R+! zqb#O=HKQnVzB$Zw#2ICGGe0=unV-EtpUgca28a6NV=wAf*-?1YDH`qm<(hwyj4SGk zE<>rQdZb`y33@%Pe2=U~{NB&kDv~*as@eD&OCP@73TOJ7@_&=L#r5)0HD1H}6l!12 zwqEhQ+G)1rVrxzy9lDGuYh)t1cK zPs|}k>hYv5dlTF<5i%+hp6BW7P9(3E-s+m%&$s7Vabj-{CRo_*{Lzj*>+SFv$@NU< zCz_58rS%4K5hDVmDf=WV-w%>u(ezYSD3B9F74RKImhLTzA%E>{+f^oRK!*v$5nz=DHeEOISg!FvyUfa|V}hn8|}+4`pB`e)6?x z%KiN3mF$^5%U`cE%2_S0(FkcHWn) z$Q1TZ*HBK8aqVL6vzSK&PBe`q?~Yw`^VuO4xyL&CUU)96F)bbux%8XH zbA6{)kyv2Hg1*dpEvJ8w=lm%HayXyh+TPucDkbP0;2GxNDSuhEzmb?M9`ZSd+{!gU zVj4^DPrL%>emdc*8$I|F6&O*{8P(`RwN}<(Tcid)!^2UwcqIPat;O}b)NuH^1U`vH z<5l#Abf;D`HxA`$==olm;Y8-p9=O{^-AQ)@VDiKVBp6d8mSjS|e+^?+<84)ye-c0gY3 zKqV&d+33HC8Tx+YMa-nXdz}t9j_6?KUfuSd>%|}=)cz?LzSD?7Cz%PN)*9c+2>VO& z2iIEBEQEbEMXcEQgnQ&^*?3N--r)=EQ;r}9@u)%_m_jb%5rw+NQ?8#EIs2@zPr4;1 z$(L(9e`Oe@{Apht-l{~ozRU^GN7%E13a_U4;Y%SMylgsl?dTA9oZiYD9dw8IoDOAI z&nou9o#jmOh7nz<`v$9+W#Y4W0iQv|>0|u&Dt&v;$w}w_dc}6~^|BRe=gsuw)5my< zGv3ksdGI1dMv%Gxl^l>h9m)QSPLXT$S!NChK%cVoFFy9ghu>VgnyWBzl`lGZGRxIf zhXcR(njFyKrAddRCDg%dr6Po0#_PE}YrNzQ!L{>4`c^}%$7`bryxdhJAJ7Iy8IM?7!NIk#V)j5o@!I{W4PkyL56%@2<> zO8C%c>31jq8`k?{vx9R3u2;{!Vz6jt6m~X^!4mF0s<(=Px)5jXZd|*leLJY1H{!YG zKORTVDCPmUhN@Rmvz}-{=~(tS`dE?Tt5AQ`E7UzWyL4TkP%q>D<7X0imU9f^5wu^P zk>4beEKl6XI_A&wG{+BqyU9to!VUp{KLoT?!8urkvi~rv@Gc6k=0!vIhU@!A9q)5` z3D?m}xyXoX)5!WMYNU6H8M7P%44fZM%VHPOTq}B0BVXxaWtSNL>*b^_NK>e{^x&+D zKbP!QsQYXoKZ!ZQEm!u*_|J**fY;6iW)Ej}OqOG_=wTi}~V0f0N>RERN~v(^<{_ z)}wB6x+XjC7li$f|E0wVa_(};NwmAkl|Zg1{^4lZlfL&s={Pyl1_eJJ!ToKI6=gId?{8Zsz*Qz?b>5`xi>^zEq}fXk{^K*7NC)n_|PfV?NUFa=v(d4?}*3 zSUi88fhu?2!#KcKJZn-%+(G@^v;lqVlRL(Jy645(a~1{qFv0>FJKRB!+O%Qaju-75Qa;p zSZaJcZ|<{^o#DdXbp;;XV~_TWI6O;ZKQ-86n@unO-8>1&3Bx-2zjQ8UoZw#FIm|~A zsi7X=^SpYESRAjJfd&0-SVX^7ZpI(^{-qc4O2y&>^|f9D$UPk6E^on5|w6CBTVzQed!T=XDc&zJA}VHaub#7?i}?7KoNHf^Ub zEX#)Pzq}~Si|9%ubu+0ZB)>71u%qcf2E)`qqIo)UOHUsi3PpN_BFCuT^l zo&n(O^~Qu;5smTG1=w#K6G>I@t? zZ^LqOC(D<~mjaJ)tfkLRj%J{tjoR#SSIMFd63Kn+(HF7!Iwk{|-}vw4+~8f~d>PB< zM#9oqc%I9^_BwWS^{69ty?C8$WS1E4Bkyq;Xi}N`p!2>GfB28Y_S7<)t4GcC8RXB} zvC>*sR#g8hXHvt^gV$~Q68!n8i>#aHA#0B~(VNCT>v4SF$I+*m#M#WMdh*Ud{vhw) z1DVXc9LwO@*3KMQU9l!R z6zWxJ)*#F+uP4=$MmFK^DVOXm; z1P{zWwNf_Z@ZUR}zVE)g9=e{|Kz3gS`gHh@=k6wR{uW5Nd0}w#j)U=31{x*vv zSC;~b{Lu^5ij#kO(~NIJ>e<$O8Rvcn^{fCw&KeU;v93)rqde<=A_aJ|^H+iN$^i3ad zkzRfUlA;d7>PNAdb07oHH!~NS;wh86A=*~ zL}|$V(bVOf?Uyj%DnFiZ+<`-G|K%R2H@oYw;T*Ydoh)eYPM+6+WGV5R`<2V|@r^TJ z7`4$m=N)LqT-`}>&35s8853&2Dqs54m{I&tZjWqytitBHI_3)K58~c(lBWZ+WA@02 z!OYvGMkB_FS^>4vsv{KYX)f&1*y@e*g}6VQmW!yV>D22M+%tYz())!-ka^Iz)PvMpYq2wpp2a})JR)rb-cU^zO9_l4l zY@f$HXnW2YzWR{s7fpN;^De3M2T;p67`IpaN~)l{&3RH~!L*JY_NzNtu;=3XWIYY?};OpO=`hs^2`m=s2@w+t{S@b4Fa;SfcqsXR76+C^?Uis(A2g*dRi|w-!X{-Qzc;_WMUqrnNPi6bnk%(p zr_y)wH&3yjIzLh3&eI21Ga71@0dJ~XFoZfn)ka2U!F@6E#XMZ_p{90~J~ir7Wtt?* z`KmscyC(|e1{h$f#`k?PyE9Jgk%#T60j-XP|J7t%UPxWPIJxosITye4MT-$pSl^cK z`wI(d^mE|&0QPTvWv7+rJS^w?zSGHqe+JR-c5{#H`bDA|mG7E$Fem!s^pRtk(R&O19S`27; zJPY%?E7X=6MsfM3L>~=%t>{y^H6#n)8!Oa{&L@fGy%PI*CbPDrU#uv7$MpZsPu?Rz zHGQz%MTc1GR;`!O7kN>kzWUQ3W4*{vTgncUk9=SLdp$=nYrAN-#8o5Lg7cO(2iebV z&qBFP}XY<&0M3zsm?-7G#mj znVGOhJeBM|`zH$dI}P~JfHRzS3U$mhdb(zi6*7qV>)vGl^ZBrr`K1@^i~l*E{K^~i zu#)=e)d+T?K%tHpWt66`d{LC=oie`c89$PRv|c6zAH!p7}h{^Ez+L`OgHC151`A$v}FQ@R-}w6U1^JEiAbAB?6idr>*&zk}F|V&`*gS%TD}ANe4!^Q-{+RkN968nip zU8{y*Q17&aDuvVgIBzpmS=K6T$IE7?4^QkI(qMqr)Um94df0`akZQ~Jnc`oqO=}eL z#uT+?cgVa0<ZPcC+SVQ&n`$eS(=*iE1WPbZvD+vTU)}kxmk3} z27c>J?-~?04fQMED$LqC-RF6c^zq$Zn)aUgVw(47uQ*jT%I0>7@`Rm7Jqo4BM}LEy zy`CsPwj0F3KEXpN3|)-{Zuy)P2_QJu&Q+ zF2C7V{V7=vv@%FmQ~tluD>=X@dm5yQsbrEQ3`vs2Hp%jgQE+l{hkh*J&bshf#hgtW?44x)T1!lu&ZLI^^SrV6t-ta&Fyt zDm$W$N)+wO{`Sf$oLxtjfH!lie4d}-v+sbPl3XZuqbsRFKl4TBPfF}o`{LYvB@89` zY(K5UW1i{9^Y17d${vrq%y!P=Oxjh4t`Rz<^IH4yD~b$oYDC|n(S*LlhwaJIxf_kT z-FW|AB8!JU#Us7B=I*4ww`nvoI?^Y;Lx-%_)U`L0F>Q^;_&YI3aPWHOvu|{R7)+Q< z?cKuX6g|FSBXoH5g!jOl82mk`L$Dj!kiOCIeZbBK-ZOqr=xOiBOf9eZliQgiO`tb= zz5#{3jF=H)K&jbAOf5!6LnksDnljT#c0|ty)MGN4$DL$kM;K?!Ey-}4$~pHeBPKD! zQM{HBu4XcaFVG{|jvmEjoK3%Ek3?PeYYc<~nLwFza0wroHAGGRz9^MeGMWY{9-#R-C`f`8u zD7=w9DaR}rwloV(66t4jq7SNzw+xNgV-f~(L-+d z`%2z#cQKr*CrhkK@jUE7t;tL5qo~DqttXkSJ*C1)ABp#@E0s_C%B{BaQdL(8X1L3V zRQj==`pBk-?9H{)w^&e5hGqLn)Gl}VSXL=JyLm~4a9o86sX|ugn86kT*zsxQ<>-BCS(OvWXG*ff!Mk#Fl`@MK~M9g$hAD_ z|4@OXSqiAu7f9>Q`I51m9>;u#N$i-Vkx^gc>{V{v-8x{@IfM@HO!4H}#X$EN^xF3hI> zU6WeLP%Yl1vA4QMIM&zEvbRjjjsXqE6(J{a7W1WQb_2C%|Hd3WUgVJrUrCSU)MHjZ zBxk5Ny^C?NSg|4w(>d?hRGqV5S3QQF(qmmmc1h3R?>RH?NncfLV?CB~?$GQTJ4Bkq zVaDwLyjkqs$Y6KXXzB|M^k}nz{YdNMV7||D*aR|h9>R%$mQW7!bP+a`tjAe=68}sm8;a3Sv0^^;5qc|H?Wx za6F8ij}~?`OtrJ;nC$nk2 z50FdL1Ebdj%EYHiNxWTCmX-67uH);;p_fK94K#!`pbFpn5wSw62l~K`C6Ck#&>(66gN-4oL`QQvl^ zuhB{m@<9bGYn%`;wtfiAz;d9zxJTgSq2 zX;L`wh-dg^)H_>~!MKjy(80VnYisdidj!TRG^kOX^F7{cTa{#Rz1INK!%^*#7DqPF zPt1EN^(1*K55n;;H9KV|etc6Tp5N8r{{NnBaY#5Bi@ec# z99Tvjc>#Y<9jPnt-<`YocXa1mYZQILQ}j4oo!-b-_8kJ)%eTZl2E!@O=Ba}R_VRoFP{`G~LR=Zg0rJ&c5_d$azoRjin zddi7kZ>5G;%Z~h}oYS?YKZ*Cy9=&#hzTp|R|M3sEZD$Q0T){u&d(RK2Tbx@J((L)ekWNE> znq0qTnkI z*|=-^oiCZDmkX<=p9pp{O&{$M@}x|Da9G8CY1`e>Os!rYF~t|ZmiG16YSXcOqtiBO zZkqnN**twl-OncNl+C8dDF;J3S7>h1RoyF%uO`a^za&YWoGPn!8RX#PBq_TtNlY#1 zQ{0~*#ix-~w32;jedrPCZCS*a2lX_Vj9Q)ST91gW&1U*9@OGD`221%FbcWhnm}yD}9b{mAJl_Gs7l2oZ)`YzJpo866{L|V1~t0hbA|5_+g9Y^EL|hV>+mk zxEEYWFXKZU8hOW{RCUfkgLRnQl=Ho@^g$LxVeCO>Tc+!f5v9ZGU1T*Dis2lXXYl4a zoaRi)dXe1jV)QN!kH)r}(U`Y03YG#L{ZY(cF4y5>4%uO^$>G0az^!2RM9*NB?_UG9 zIQaVrBMy!-;@B@E#+4vIk@wi~ zyi=!?BgxzkHgJeHSp>~XDlnY;!lbbZ$S^H@`h?@+33}c4Yf*C|y(%O4^KdV7;T3ti zd`_SBiN~{xtW$~vXirbx=J%UuQDsNrFe9RI2DF zOWp*@^kFL2+6Bt83kqCaKxSlJXWVE}2z9zSqa?2>oYvy8J`%luYY;&%hO$*8bgv?z zxspWy&?bGlDaB_2`_k|ktroklJ2M0Dk?Uw* z&Q#l&k#Ot`zWU~11^1e-Ds!K@CGt}T`QafW=zvmJDJwuWAZBJ}EA z&|&vu`c;xs5HgfZ+m`Gv;B)aXpPAn$q@d1J`Yq@InbSBMk={HH`|;=E*)*h~lRCbZ zliFFUP{+QcZ*MNO(x(o*TxFEzO_<-DwNLB=66D>+6lt(vpA2^Q$Bgg3C>Tr~f?km8 zZTv9yT>zHTYcZyx4l{pKS6su)@3KUIPtYu`O^>Mhf@=*=#Q$3rY1Vf&!&&iLa%+r7<6MkveQ=s z^gi^VE->K3Z6hMMCcNb{c`DhA8x1_8`(&eOC$h=5a8^;=Nj=S?P_NgsuaiE9u>+Z5 zR#8`fOF!&ldN8ah^3{Kz6n@P8Kpgu+W^k>p?}veZ{V<6?k2kgPoDF`sRVoInE5%@2 z{TN)X6T>`e3~o%1L3jFhZkvpl!}rYN3waE|WD#6W!RDIx(7n19vXUIK(e%#0wqW2Y zE1v9UA2&U)F4XpiQrC9xr%-#5ljg`smA~gxWLaveq*qRn1;?4!ZImphI;qf(np4dm zHOX^pz{Iy;%&36=f&*&KN{jHUKJoL9TDWX z(J$D5d;L?~v!}8r;h-KfGwI2n!M$;7a$#p@!btz%2DeO1{%oeNnLNgx}ph%q@9OVAG<82?Q>Q-0&_VN?;aepzm2FZ+#O8Iot z32o0R;MYol_He@Aw$AVm>=$=hh&MtO6=Ld*; zYgcKI87LuJ8cN-4FR9ltK%5Rc;mZVv#CtiT)kkMEpjWS&pEGJ+3`ayFnfq1^D$da0 zPbm8_m^EF+nS0B@ahUv@XEVM=gScKKj-_^ykco%C&3N4|6DP^8%w-mH%Xc%B3vy6U zEC-voRuu1NN5pNO<@4E(Sk*_4Uh|QG>x1Mbxt)Kls{kt%%Pd7l(VGmgDJ3*kZ^JTy%EiO7VnD`?S_u{o!oT-K5JeiH$`?y-D z?abFBwGp$d;ap3X>QSvJ*_9W`tU64e%5r8+$J3WTmwD2wHq;DaZjIjDgO_sf@}3<| zVPrzbr^>oVDdI+6#!hVVOva5KCOx(OrV)*)0W#9EvfBGvMsE~Pty>(=$oN^6> z>JjIchq;cn=If-OX0MEakD0yPeq2k-q+k)xKtoR$kxT!%d$kkN?J%1Z>e76jZm_$cYK2rOvM@#N`_o%ln7xieQ^ia# z!?buMUI(dQxXJ%jxHQ8BoyWfyki6ny8}Riz_Ynt!SD zXVcsGl=H3&T({I#*xa+Z?vj18$BN?IZ=7%Hqz)ZJZVRs?U#{zKxYn2L>!d#VIa#a+ z={>#4b(B9-s}4q4M|M(6oj;D=RwAOiKj*W4P{yd}Kc`1FTE|XevK0nJBhQVm%VHhQ z^F3^yV}v{R8{Ii`2wu&3Yd{J{^P0Zh&dRwjJ)WM~Sg&R$Wd9yy&2cm|LbQQQQ2RH*Hw^l#6D%_dVG$sKl;pj?C9h!RYw%ar)e5Iz05w- zml^o+o4O|R&a>EeT@Ug7hWcpFqb_>i#6!6CKiL+ zQ=g@ut2=pivt0`00{tveK6;EfpMltKZG6~C2vvS^%!oO`Ydfz0dj`8McZH>pRC z;rZY6WAf)LMLqXM8EQPQUFFo}T&eBEY;!idPq=PWiMQcl(Yo>`@voG=K;8Wj`()?v zSy#(`cZJzUmHbB@Um;I$QXFceXJAt`8=kImm$FR?V*$m_w(!Fh#)Wju(`u#b2% zwY6P5Z!&K%Z)g}E{bp}(@l324L}vd!Z@E;QJhjeYP+g40ITL+nVAiaOr)08Mx9H5C zuz2(Q)Py|5Z_HSnR*E$-SJH}vBWF-79>&stx7dc(PdKYNn=kLm(m%ML8fYgoO8VMx zt`+;cZvB-7^sx@##7Uzw)bF-hqy&D+b&w{WEP{rI*)K#5`M0m08bSshQ{TMa+FN$M$P@p{WK{6)ozN}=&6$CyF-0j0Coor;%wFbK zu~<~b4DIIk*fpS@d?(-V%#$z_s>Zcw6l-f zU)(no$X+e|bVXuOD1tflIrQ@;(eXx17GVB$e1(lhb;Me#V8o9v*Q|+S7(%5#Hi2`ErSSNRRKa2vwUg;Ue|p;(_8m zJXc=Fy0Uz_uoPe*;F_mg}H;`6XsP%KV3 zGO)_QUZ1w^vW?t^V)0?HD*NG+Yob=eags}HiyHpdoFw4%bT&n&xR3v9gfs1 zkiwkL9k0*Mvv>3l{vg+KjhEE+;GXN?Ww!OoM9h5XH&=WYRcVJ`7&n}eW0;%=vjjq zVEQ@($-O{1CwTBW@5BA=?_C*)3gs-Ss-N_vUvft|Em}nI-!;X|t_d4@>*~m~?+VU2 zH2BAj*P)H`fm77nJ9$Vgvf;;5+sL0lK5tX{$`jZ>w#8lS*O-k7WZ&F{Sd4qk><#bV zHOX#LznX$PNM2WsI9sg7=PGsl`E5L9qbgS}chw@jv>uDUvk$$r9lw_tWrY)cQum{9 zhv&;?n=RA}=%1RKBwUh=g52cVe_%1S-P~l%ZbRLYzOAO^ zj1s+&+DH-h8aFj!%>e45-yEoOB2iX)vpe#AG(v79qgw>ehw%<(fD`4z1r_cxk8%2K zGR8$&;6iO-gTo;AnI);_L$APM10pLh>rg_Ww(99)s-i+wRTL)AHo{xUK5ObDl?$iJ zS`YeVF&b2-V5r8&OX?5V@f>B;zhioUJN3ia-@3G$&neT6M~-XF=l zJoiJt`SsJM8l`1>AN=a9!~MqeC3WZAKAwBng?r@ZH1fg@%){lNP^eRSCCYK`Q><(0r8vUg zVQ2pQ%xuK=OOgxZ=(XePTv$u*0=45hJIFLoNS36H^o0!4VM{&cbt;lWM_=CBrz!HB zvx1r)QMk4u8E?O2!Dlo3J2vc*xB~jo>gzBk$%xRxWG}hVk69-{rZn?Lb?)iQj58vp zFZtXF4h&7&E&ly{aI#Sp>YicdWH?z&l@#iPA_n<;*@v?w`VH^${h~HqJDGjNFh~OP zyH}6QL%B9aJYP#6-)QT9oiN*Vs;Sw zXL%;jkOj7PJAEyUqVX}3Sz5l2pOgyqo}68xDyqaH?yrOS`hQtKZ^S1D)`#sCiSxmZ zkJQwb8{itlp5L;}X>vC6v$hgzzDMC+9<_Q6b@R96=xGvVO}HPNsaYI3#F;^3awmD6 z6ep{G+;k-ZUy;>aiZh1k7Cch$dgx=6o}h--jXcfjWE@c6@9?VteM_>Ji~h0#8)p~p zMhrh?A@@k3E=HeEZf_qPeM#RLIen#^$d~L(&4;s|TI2?%X6dkoGYjLCEbO3PZ<9S) zuJ=}9Ri|iFh&Lc`D*dYb`VI#AG{4a2+n>E0kGLltl7*N_4rG!$ndHpQl@HN)zJdO` zUs>2s|LM}mB*GBVeZze%63a%F;Cj8r1FoDRQC2K4N2 zfvPTjWcA2@bWvgSa-Mb0GaqHP;3+@8xln?5X;s+%G79axFei@!I{#}zSt0$$K_~j;dRw>5n1l-=!Z2W%9xqtB(g8N%nt*ub+VvuF=m`k?v{&#l{grw zLyKw#Wa_g}jJ`!(6lZ$%__|%=(gU;ikQKK+@%BQn1mDh94qY2`7%m;(}MxobW`m8M$TR3Iu?q0A|FqStJDxhRCVa2`fK=8ks`R9muFn*OUqDtWAlW$BsXd8-$n+lMbC zN&x-5$xY}18*0GB;QusVYMJAc&NU;W@pwLci$U~9@xCz5O_0(b z*#jOLg@)~nID5l_W+N2p!LGcIW_qKcL5HKO$zu(rAM2b0lMfkWYc6}wheadk4Y{|4 zt!P#Mf6rn6KYqp=mUX6ywKkaUeA$s!pkCE-SIdzGzy~ zrg!?TLW9%q1U@jO81A;b(`cosO5*_2$F&1Z-y}Bp%%jff(ZTgiWu^{KUtd2dWYCRq zCR4jEruwnGAIL@gGBQafJU=L(dl+OvcCsA)nkWyirpTs+336!TJ}Gcck~K})@x3lt zf*S0X)$}z#p1Vf^bIH;fW0aztOYdHmC`niM%CLyNQg%U-RKB}MUY+3gTaqMWrzA_* zd1?*RJYH5zl%Kl|VjXOda}AQjXU0CM#_Zy9FN1WCpaSo#AAMst$a@OXC}azTn3)&pD*&m@fk|wt@XuR&uA!@ zM&mm*p_WIZQAJCCxsU*E?%ya(8Bd-f*YvxiqHvL3SS>Xq zU9A`_YZQa=L&;Vc5zUSS<{iU1_tw+%C|qYak8WNq2LJNc%G2gi(`E0)U>&=obhy}& z8P+_qSeKDUynr+9$DHr1pf5a=p6E~P|7&HyMuib+oUg2%$LG)nBVKXdbDp#3JJhZm zTmu65@gAj8Q2qhu47p@Daz^xb2^rX25A~l7@R(*mXX-eMK<)(BhRwS;i}+x~l^I4X z9Zuh4X?6SL2#m~Yiu$e6UkbqV`JGWofN?8D-^dw-_|>swn9ev&NbQq*LwSm4I}kn1Qb z!hEe5*NI-ppINxZy~>?K%rQ5!;O!aS~zT3bC@_0yXvDI=B^*s+M`OaN-^mUg}HGRcexvtb9mvQS$Ul}sE zo}_jNU?-59l-$VvfXe|gj{OMJ)7-@rLC$>{cjl8C|uGW(Q6rVjfnf2dhcm`Y8ybgl%vD3GwX3cTE!FP~@SN~5Jt zxYwvait+QkBA7pAANAgH`7)xv6L$Y8peHj={1Wm-v&JDqiv5*)$MU5I&(rnn4jFcj zJrX53UtUuPqu7f(ZHN>5gz2v;>;$)Cxe_tL8I`*#@aCsOE^i9QYHBj?A8D~+l?J`n zhU3Q>`V76aX!ApZMu);MdVV+}cZK6KXVbF=hhq%SXzF4byxGDIK_B+hBLC)T5>B&%LFCphDj#kV}UW-HPz&OlIV?XpbYBK+w8-Fmv`6LeY>6eiKi}JvY?-cl)L+HkfHCwhI+Lf6O#jvPICMS4IZa_bPNXu^7@)^C ze$C_OWXvVRG4sOCrj2n}wOY@4I&*J@%}AT4$dlwDUs?Sm}2I&aKa zIx`ay;p_@oO&?YWGiBwO^*_g+ryTZgr1I;iM_ryyrVVwhfj#NZ>R=}4+YCEBSoN2Z zVc&$zxYC&jtz^b^&rBpNq3$#}6Q`-)JgvqVNzqJn>}bY;YBscWE40qYl zqZj!})JSfGk*B}Fh8|~aI9$?>#m9JVuSM2DU-E!AqKKy;sL9!gEZxrg8gQ9x&dDXIG!7%n( zhxth7I5!En*jP*sUzvZ`Uwj`1NQXu$DKtbWFVnoFprx18ozsx{1b0b$7$k>=QG0k$ zU0UVWWAB-}bR|P*(F~Q`Z|@@JsrBUGK_4k{xvmtM;wnz_>dD)C^`!mbda|*&mq;J_ z9KCsVc6f?1(noeI@f4%dM;cD@5Qk1B4{AE2REs=mb%@$fP^FKT?SySos{nE?f{72Ru&-4X-VvD;&} z!VGpNpkgaEGl1O;3@UaUrR*+dz)mE->wMnpy}p0I`vVt84h+NdJokO?z4i*~rpvwb zhh?lEl5_mAfc)N(oayao?~g6}1F-3U7Sk4KQM+v*4i3@c>pOpJi2n~8px5GdevaW> zYitk>G}0n#VgSbPX71OyAjA#{#IF@vbm70{RscSAXC~MSu61GoS>w2dUeOydBMiZt z$TMVLue|(Uz8rHj#zdeJ@f3%$Tn9@c{+Cl~oKIYE4?QiehT-Y{FeKHX-t;wjiQmHU zOh;~TyKu}L%v{W|5zvhxmbZraom|KLSCG3xET_%{dV~?XxzwJ%sCy$YsSJHr$)#*t zD+0wMIb$ORl(vjI>KPUs=UN!Eot&0Zskm1o6(OM(I6Y%_$Z&coM$kj-9`*Y9#BT0e zP;nsVtHd9dldrg^CMZbGPd*0M-5zpjJT6+$^$fMC?QHP5M8DD>e7>i0&bP$|-ziqy)=~?)!-hBCxgNOQ zIzF(XD3rb(oDD|RBo}Ep{YzblQ@*jG=}mrYr8i6wzjnq7zYgREb8S6P(65TT$5A%w zP}g(q>|_p055BG!*YgP*Iy|@GVhR3S>0BteRtwMC;PIx6*|NJwr_YH;I=S8{bKN<+pS9ST}#*GHoqgx zuf|U?Pc7FrDPl-(bJ3x4$tRlDN$x(Obn>w!wUaLwI3+JL9WoDibkRJmW!I!9lUMmD z4x!W8;oaL^t5ZF>akH8}@6%(=p?y}FI}h{i7}GC7(muyZhACcJwTcscKa(U6G05OS ziK3z=@LS_(xk-)QO!_(9I$)9w)eQ2hVXQdaG}1fOAc21wCGU$t3^{RfZ%4Gm)iFpY zJs$hV9+b)K%^E^xuek?B^Ezb<88V-bgV7+AE1tA1M@-p z)6m-`Ujyhbu<=gTt4aGn6F2jI@HOK%Q37rv*ex_FlZ|4xgFHD{4(P2 zJR{0ZWp86M!o^~O^DKVcpda^S>cf6A6W|^B9vLPe#)zlHPP({LmqyMek##~*6g!O)Q?AL;um)OdGkyY@r-yp5#n&|O>lFe{-rdrnLS4A{*{3# zYWCRdw`L7u{upb(T^-qbIZ%hPp7X%<)Txvr@6a@KlQ?YrU1(gik ze|U}$38v0rYYKjy;(oTD>%M$0B0rIXLHu_)*MIAOnHRO)U6wLyC?Z5HgT8x7@E{lI z6lpJ8IqTck$&OrE`f@K}PUp-LSny4O(PeoKybMB{z#!CXr^U-KE%{{34ffnlJwgO- z4x=}9GjbWTS>sF&$GNBUYI;sA{SS2$OXx$`Jq6#mhtB2xHpep;6|3bUNo-j1gtL@E z%oRIAew?d^So2-PEv$vy4EKyXb*?#1#m2haXW_vDZW19`Tl= z4qj5>iK{55Dy0!?kfb+u7*UIu_)l^y&ojGoN}(wG(UY+xXPAcq|L2pohu5fbPoCeb zNz1Olu==Ndgl^cf56T*?-(SkC~=_y4H$X=&ZEM(niS3eb(A9JS2XQynVTzqDo zmh+R|E36N1lmC&FrWQ||Qd}E)O3!qqDDBizubUl)k^^#MvmJK((NnWgv8)}d!2U=- zj9sFItpl}7*Xf1wJb-zSoZS=kC6LoiyHL9HE>>X zgxKLz<|@6(MDjL;rtqjjbC0tRlZA5^UwRLQ7h_~^qnsXhSW0e8kX^xv(xR_X5{Us{ z7)L+j|2P=&9vHGz4WAz>Og}=8_cjkA=#Ike57RhBC&iR9RDX$aX%XDJ=O3p8w7AMGn z8%BvsikF4&K6Ly|5!HYbQvOlt@Az(H__K^2?XD5j z7O7YL5Vx%CT^2^*&Ol}>Byo@4#QEmcaID`Nf&Jv5edO6S>JW8J<1EPZOo5rb z@~l^!iE46Da~;pqZ=B=)SG#v&9j|bcFEzd7Xd9lVEj=XjmW$lz<0wZ;70aN(3IwoU zJluzT#%I)GljFujuEJm8;)^9Bk+y=lie}Syj{qF zUy+It71>L0A6&G-La)6PEM^~bphO-*^T^kTrmwrR4KC~z{Je5ey&HA4KU+v*xVJnj zQpv0m_R^!2QcBlRU4V{D%s)b1ooa^3#8S^K#bn3#cH=9s8&@AhkVXgHwEBo zPihnPY)7zjIF_zpo+!`w`Q0L*CJqsJfIUwP`=jOb0IJChiB>%4|4^%Nl;>y`Gr`$| zRCmh7!!n!;A0gkpFExY3Zt|?Dmu&yrRs6{NoYt5=h|C)3`n8z4i4r&;Tr7G2eQlOM z9C`-vZ)dMLB8am_@(#*tajYN=qu;Ri+Z>KJsq7nn@GK=C!MHsY?G{}?M_!Xhw=9@= zfb;Pae2!Y@qE)S2Xrrjh3eDuocA9j~hkkh~G@qBzbJ)uyw`V6xJ^EJWKTeQ@-t_X_6eD4q z)!0#2jU;02p2K;zHuk{6vhJ8VmmKp6p`5Ale4newxaFbftO-TQ?09tENneqRMl|_q zz-u*i^2g~X&vT-SJ^AHBIlt$7dCxQc{2+cFsnFcwH9EpGBa-iDM^}Yr>2QUnkB32K zHcpgR)KUD?!64yXVkN%1QM^m2QS*=o`$IJ@g;Dz^?C0nM^PSv#Wf6O}DxoNHLDgP7sUp=h|*~(m(W51=r zLO+}#{=2`q1)Kk+-&q@#^q_CxmWRx5of{6_&=e@!+Tb|7sr=(yBt5^7uT&-s{ucHa z#4*E`G?bPj^X18QEjrc<$3>oT2+BbY^HtAwQ=qMvKMF5Vqq{MMIz9R`PHrj(cIQjV zZhw3U4ad;ZDcJtUirr!_6C;S(6aS8@_J8X3RR^tT?e8cqwF{+Yj34@Yhr?|J`wL=3 zE;;sM`A30uKK^(`o}iGI*SxhAE0;LQfVd*jt`5MM4LoCJr{MC@9D4jXh{|LKwVN;N ztT12!d3hD7tA(pf2r3Y_CjO{)in!ab3wXjhe8)6LX`#xO$~u2s{J0JGXIqf|h1k_0 zwUiGmkQ$f#5VR!>;V;Q=QrVFDjeNI@1v2@K9~8zgl-ZJkW4u0>u2G9XEx4ZghuDE( z7<-p|x0_aM$aR$IN6B~VOy1l-VHh@^xv?j6n8)5!irW@T{WL%HNejcpS{97EXT`fS zUefVLp=`1Q;4XP~?SCdSi;F&JHI(wFk^(_v>7Czzz6Gje%&KO?^Z*CR^7te6aqLeX zGsm`X3T!*Am~opt%9{CdGLU>LS7M2$lJRE%c}C^QKecC0PCj#@^AFRCZ8SGh)*07>kfTJAz^;>GM3_vq2wOpx;g9@*cq%#s>lLAfeChg-SJ0A0Sk{qB$F6Uo~R zO+gt2J@<1QW{xPsz}5rtrq0ne4e+C=U|-a5{_m(I4sixrF?|+x2DC zmI86!7(k9QpTme0G?-~cp4LsyZz+-i`~C2IAu}u z6F#4xaxi$EqjXGRcECk?WVdB6e2M(NSn6boU8UVn&a}uo8`LBmKIEO+X~p63Dk)Ws zzc(%bk$ag_+>AaI0n}b@Qp+7aZ*!*mVkh^3vU$n4nq@^jos)Q_{+3y3zQ{Wk1_#cE z{4SGs?Cm6PIg|LZ&liCfu50pnyFAN5P#u-5YfvQp>3ev;FboeDreHO%=e6Dra`1DJ zOlr?ertmP>meaS?9FoipA(pkCP2yFr+8L`keRcqOY>aq3???%0Tpju{KwZqR$X0P%2Noh~dfN}JFpW_O{WN4c))d9-G=t$eYdK|eWr2%265)`%fW&}SF9L! z!A(-Ae<{WK^|W0CR`I#gai7%sHD?}}g8pcJ*gY%E z^2F^jhERXw+e}^!{v|In1JI%;pR3LmJYH(WsM|*QKptOuUp@DK&dR4}pfziOT@HsN zk>`4ZiaL@^`l*qBWU0q9ko+d^no6t*(&5fY1G-PiK-?Yjk~SO?dkej_cLt*YvD)9~ zGvPl+q4~ZnN^W#xW+iiMm)&9>aYOQ--r(om}JH9j^ z3-7NNHNtJzC-D!R*~LFtT&p>P-wcZj+O>rnUI#Y1Wmf~_wLKUs6EB>Rw92V zjy$hpA@rs&Ag&MdtjUj?(mF;a2e{$FsSqd>tfh8mVA75v4DTE#gLW&?)tA?80c$>D zB_H^At-ELt|Hi8S`M%XYMqU_kf)Dc*nljYz%)G+9V2chrUm5`Nh7wr!eXK+;gkU#R zptgU^83R5{Brj=SF{YM}mHWqBQE^fT&i*oBR3QD!{=;F&IjQ_ciJMLIsD6=tXTcfx zR8))~H{ztjO!}Su2!=<0^2LfXuyz=0rvpa$o~|UnS%>kw{x>RT;rBnpa{4Don{i5H z#0F!^5+l~HW&KQkWd-U+_B?juEIF7Nea!9HM87BED<7Q=5`4fFxw;TsSWO=Q@(Tv&0bLdnL*V<_-9J|D7~EhQ8j59V6H5Kg03H?N zOp`cyK17LA+d`1@jd{&&Gti1WJCzIdF4^SR^y2&JORc3Bb+F{;J|G|H`Fv`n?gnG; zEFsMeXJP6wixB(NmuqX>@irsn{H-6LA<0J`M>R0 z*Pdn#+iC{+n+Gz`_6u{m1EZwO1to^n55Y3>=Bgjbz>Ryw$bL${$WKaCf2IH5^WTC# zi~(DV5iuuPRv%NM;I9675tTmt*V1vDA4A;|L|!$ZW(1$-a`bv2S)(P?o zml&mJwHtcw4@SEZMqE6ffioV=+$k3$8hX%qwx+k-A@Z!b-xjVcMt?Ou^6rwKs13$A z5Bh#`U)scdV@acU2|cGo@N*sZai5HxlnMLZ)SSJGmrFl5zxzi|Zw?by{>Z?H2gS(h z5hEG%nD6{y3El-#`@A3vYupu@SB;{$-rew}OE9Lok}uUR3%X0iX!s&d&JUpPVMWg8 z%Cm1=kb!^s^_$ey-S15=mF7Cm^Nc7lkoye#*7Eb?CA*_Lx(Bi!-^~8?B@9Iy|;%Q;4rjAw2&*YB3uJTG3mB7nVe)-3~CouRKTG0Lm-b{WN9Eo}`w@}j9N zb7Vddd##;37fwd1*uMm0Ux)!N!^w>bD@NO>SZVu>9JvE}lpRd`{1f?=-2eZZh5f(q z8AlyG*{R|9xQ@9mw)&*a+-)AY#kc*gykwudXR>^9mX-9WR;E(N`uUcmnbWFv+!kFk zSrO}uLYd!D5u7mFP{CH|yv-}z{D@wUi4Do; zCvL6UYmhKzKzq3wL}NC|raCc_#5r_HdNnF8$IG3;CZT7GgnA}Qh0HkS?Zir?W4sjj z()aQ?IjSq;Ww0_v()fJ3{)m&hwpjV1F^X$l@DqFd@M>3A)oa!^9es@#mTaP zhdJjl$@e<(Qr*cYFV4ryA&{$H+YK8lso?LchK)1nZ+Xm%5YCf%&J7(;55>lue~foS z<$EeDq&MT+5c(`CRZw%TJ$Z*3SGK4ybEFE__K~yL)*TL8__eqE*=24>oUFp~`YPP? zP+|U8H?(Z+&N-zTBRZ>bvomq&zACJ`s>DC%)tDtNXI^e9PgW9>K{p7HnW*iJ3!QqG#a zjp)ALhy&aoUxgTPi|hC75ze3Yo8TG348U0Ojn~r0q7}K1QPgxk<2wGyIrMN7{I2r* zJDO0pz6t+KU`}9bdcT(7dFf=tqA=!3ui}|%Pc5jCbCT7>-nSdE)gGciH&LWNuEXSqA%+k`)oA5 zm4%5n>D~CAKG>W+*W1SW>^aZIEA-aUF`uh+HqU`f9B)AX4TntJ9Y?-m{VW`zSHX;> z%&K}!oUJQsv3bm$f6Je(!mJj)P6h5$Ybww~IM_qlbaoa``jjl#!kbAc13el2U1ZNidj6BYHDH^QD6T7|SxdDfZBokhU{}do<0R82yGs2guJXL2 zQYsB8kp1KH<<3HKs-hJr+Qi)3ghKhzRe|N4eLlTN&XuPEmmL)-+kkw-@B(SS^pCVD zpysfQ0&)2YEUZ=_p0zlabXVZgUV7hwhxMFkI{XO01tb4GTg#fp zAFU$%(AnD$Z#@H0+szM4sM&hxOTN`R;@1ZH$hrHocVUhLd-heev>13^i;O$$NBS}= zSIz#l0(}=gYw>0=v89**jH>KUZFV5mc=+QbzxVh_Kg{-|r(skVlrZ+rw=_KLuV7wm}_(t9Y7ehnQWFg}qUjQt~!z9bxpe{l{& zt!r!I4R@%^SN9Ib5n>e`eCbUi8i1rrZdhDB)5u@=+#WMCvzm734;+zG$7E_0J zJQa0`kjXJI7^wk%G8rIiJt<%ydoTd?o71=Z3mh!~oT+4rgEWAC@jm$Ram7Wh?2 z#fHVnoTbq7@dY(#oJSnVO2GsE?xVGt+4PP63ZFT%F0|sYCwT_!Nq-K^Wlc$qXqi0J zNwrZg%o+Py8^+t)P@OZK?~(M2yF(AT4%Ca14={rK3FA|0|AvyI=wd@}eqZ5z`Z(s$ zt8sNM(l>BEzL;JT(d05{tyr8+4>`{4FW2YSb}_Gt|G)23&hkGHAKc<5am~~+d9}N| zCFWJKYco;Rc9#kM%z4=8EHlqJi}hz4S$kY9mzr^&wb5QoL!F5GxXZ+O&1La*2f26G zNdiZbL!9Cw-I6^d#6Ydqs-Jam*w4Dr1Di)N#l%T;wEP)O&;T{ zLbYrf>>{_Gs3knJxf~-0cog$PGTn+~1bK#P@)UzN+F|6)Vq$dE6`m}VM>~ltE~X|i zzF52l*r5sYJx+L#`$#Ti_?SO(rH&o$mgSuP5xI}Yi{;NRu2pg*-qDlsOrs+HtqSCB zDU`&?3hdfU%;>BFowM!mY=8pond6>FTyEOBVlj_UATiM&cTV|X(IkIl#B<$zBR;^j z;a5+KzzO8^9tgl=YL9DiP5AcnhkC6a_SFkO&{JPrObI~mj?BNAOATpc0R4ahP$@%; zUeN)l`N<#ks**4A(H}{-$RYNir-?u3H&*7~O!mjDk>nI}239`OA0v8jojQog@4``%xbW;e&P6{GSKJVe ziR41IzsYP5PyU{#%(fsddgK>zh7PUK(Qtj6*(W=T9v*}k<=V# zS}^Lk1*cA0@W8^1_GD(ey(j0lKfPHhlb^Vg++p%hHhf6IxrWqqt{~3UGzA-PTc8gi z$MG@O+-3_V5Wi@CGX-BcQ=3DLe_#N889S$<{aNa)dvcui?W_q(a-6?r=_(iiWuc6OP=ila#BY(^x2N!g5st}%Jd7fo1|7@JkjFo z>W4OON|1xE=$W|gu#8@2lCgQL<-1ewbw5EI#>Pn=`39B8M$4LR2D!GI`jqwtc}RWC z;cxNMqKQG$dld1$& z@|eEr&E1URH`|twVRUzgrhs2-qC)9nH69z3#8lm}Y>XPqB9+)OQH63<>G^b7 zg&VtA|F57nM$0@1)`w5Y=h#-BoW@bq-5#eW%N`Hr8IZRSsKaXJ25cwCWS4^aMe;kQ z@xR|_^jLRYhmgj4^uHgBP8XOVKu)8527Bi%^i!OzM+m=f3+uf#{NBI!lGmsW1swF~ zJV6I_0B2mbU_@*qw}7GI;rf>e^>>r!INpf;HI2ALEKlLg8nPm1 zZLA%Cw>LsJn>sdfR+5Q*C@W;)W-ZR&KwZnXOq`2hwx(}3UX$ZEH=g{K<jL$eeGIwcoM zw?V~nvb+Mly%accR*S=mK%@=T!ciHBTD(>}SnG|N9)Z%Ec_z$?_+JgSk9>^&ZajnP zrXqA#Dt>XVe_bsVr-<`^I%q-jZ}hC>K6sk-%gU=(^evqSFZvb8y`++}d{_Tf9eFK1dT1@>$ z50cyAc-gQVaBE;M%QJEU10~r`+k2Hjmdxs1pchy&FyKj5D7X8_zpC!X1@LtMQ8a=Hp4^4^9llgGh28esdpX zkKL6y)7eepVPpTfD2h3d{-*!s{=7Mz#W`yhUe~2R5&O-TEi>_ZDzgB_DKy@->@;bG z)VLFe&7Yvq98c#Ao#)G%>n4dU881g_8>LezlSD)%NCmSBE58yKdPDtUDK*w`kN>8*R1`|4rN8#1VMXFvS-J^dL^nJ|g_m;?P}ryOJ6 z{n0Fxuat!!_T1ANDKw*rqdS$g)6C{fzw#=Drud6O(|BUMn7+hIeVa*!li%-2eC2oB zqoS_pj%nNIyHKh*`z$qj>D8F>om$LnJ^KD3zu=P&F(r9@CXv6V)nn*c@<5IdKaDe? zXq5@;29Tq^llb~ka#DDG7Nk%=o}UTZ9OfZxra!KooyNB(uM08x4(ZgtGjlqTcz(<6 zhh<28a%G71e53Dj`Fr#yn|Vya$lY1Zv($rGPbHSC@E5U@o|oORF^4|Ft$9AR=UHS= z?*30b)_&9D=`x-ht~@Wu2Psq~;FgaG!#bJJ=mYr;R%T%LW-nimiQTWWP-Qc-p2)js zM$Scb-mgKY6q*;rP~&*d(mTb7$J%%q*uX>&R+IeMMt=Dqg!Kzb#2jQvl`aGqHk zZ|IA-(w+X4dR+D5tfN#Y5*(>vk09Q1i2Q#I^PGuUqm5tCdS*W;yXB=@6H8IM8Q~BJOd0qIqfr-x#{R!5# za}(-z=zoL$wX?Kn$v(dq=Z;BrBhawzcJy0BA6;uWXpbG$ha(I@FU_}Cu}HQXDYQR~Qg z`S_I)&^%|~Q;EG%TsUl#EHDxaNXuluVz59Rk%~N|U`>B!7caD-2G7*1{cu*(@Nk1c{Z0DX_1%B{EZ}f9mh~R_nchVFP!Orq*r7|))!@|;rN^U5T30I)>20? z(1JDW>25#dz4GDgI^2SdPpL~||5MgG7Zsv-ZalPM=YAW~chSGc+gXw!CJxe18>2o=_3*QX_u_^NVxT*cuax*8@W_ zn`hU~mZ8Y!xslW`6qQ0v=#$0Tcr!ihICuMZrU|PO`H@EbcM7r4;w-F7roV6mH9Uq) zEO?;MSPyak>uaY;;an%0GsYdW6q=AigR}`sko|@1!Dhru7pHhRev7lyInD8Xni^y4 zy5sE~cWkcVj$FPU9p_kA)`p^Ky-?;ogra&w^5LJ+^MmKtn`q*{tnK4IG2=Oby+W=L zA1{+%`H@*xpE-ALN`Ci7`qjRr&u~YDW^sS!UTsupN*<>_>{^B9{b0_ynC-l3xlvqV z$gsD{L*J4f6xaZO6?~% zfpev1bD0BBM~wuYU+X#FQne(9@iM)NI7c>ZqL%F#dr6)b?}o&aXHP$0-YfTA%uISo z{n+0;<4e#FvG;vEUd6d!KW2mLvT!ahi})1JhCI%t`JOuRxzX`nEx1L05eJhLEip*_ z21n$@TcgZ>mmoim)4Rv0!n!YN_;SutEmw_=JX4!K<2gS)6wj9H5xXW7ia0&$Gzvxi zGvwr_QX9}H9&2mH5XLM=a0nfOVUr@jyg7;q23o1n!(+9 zZbd0H0rZbNPCv{4+lOuM+E_mJ`6H%w2It`V(i_)2=`o&i2RcxyhM7;7;W9d7K{=YW^P=>XAzwariIM#}wl`isv zSa|ILT3oA3Zv3efjJ-`hS}8|4M}FCmTtB#!BVN2O1=G7&vDeZ}%6Fq*z-oWgSkB-3 zI2pq_Qu}?=Ri?iFDP0>AyY5B47|%od3dBV1n@IYFKk{L{KT6c0&ex8(?F1Xbt~$%R z%6$Li#xHKlv*S<-7W8Fb^R|)nI>@|WfBNoqW!>L{KFGv}yvWD#X8!5#e#~siB^F-N z!WrVGxR!hv9W-GXC==y!yaR8u%B8H~EYk=7zy32`v)$=f2eUh2ai)WS7)7bUo-QC)Av)Bs1stA#-WsQ_yFq73(S~ zrDXr#G9=v}p{MyA_DVtW8DfF0c%Av&x_E05dvzQ3RJ9=EfE5jgH4sO>{$5w+L{Fsu z^cv=sucZcK3Ui7E(cj`+0M^=v;n$uNbXKvxim?}6twO1$_eWTG7`Ah+5OT!|@0ZTf z;Y@+(ID_%{!+FPM`U&c+n0?npl9v3DMbG`PttD#%)=Fss8$vkt2tFF?>Kc zdQY_A>Nxs@c2&u^!cx zXIBer8=kM1oMdS5A6cGFUhoO>VZ+H6K0+Sxy1G)kOTL&^24Mf)FvR#;Q1U$UreC_s z?p5?RY|XsvN8$K5g*A=06*aaxib>Btwi)jWd+6>JSX&&=!O5FW5_h{$`WyU^et8=% zlw-YEgV%YtvwW%bhrS5DSotap>AzC2G?aN$L!BichBeP?=2MRf!}=A;xUI6{KIeF) ztp)P;H9s67rsG(XdDFs-t8I-%N593^6WA{|p|9%)GprHhlV&!Pbf-c&#`k%sCOtOz zcTE{+MM_Oa$?>NZ|l;nZ6#&As!*zmXr7z6ryo(dFT(xD{P#CFSj@k%4i~|FBFQ)ZRV;eh;5CvpfunAk4of0-})taspOR}p_j=Pd9N`G7iN{4Mxgb=cKVjye{|0<%9>Y$JbGlY*+m-Gd+U`Po-2 zeM`~XfwlkF#(Yl9IcUw{*z3apOfeW}Wvw;#+^3$mj73}^Wopun<{%$WPd8OSCJnnl=9s!TK4^`uaK z*Y`(-F5%dtOu?wSoCS<*BG#S-(wFnjLOv&3JX7&*a}H))s4x2aMe@%mE&ARKhpLMO zJFPibUp-cqhLG>pU5^+Yvuw&zZ%y9fla?mw74M3^L!2HZg(~9K z7xkDCYD66^{SY+@jh$<>+$OK^>kN1pNB^~>#h5)QR?dYIpBSSD(hUf+ke}5< zp?Q-YBhQFce#IrYo=9v9rEugER2$6JzX(CsmDsC3HxtkP(#oB?qM%MlECIp_39mvqIq5%Ydi*GLaIa&`hOYSipHVETE^t zg-i6U3m^xh8GDDj(Ng)F5=kd@*!tZ>4heHC8rkch0H7iPD$m3f;U%#Dp^v`l6->^FQaW&$k6tTRO3FODE zW5y?OFxBv4`ew(<%rz={XX~)vYQSIYCtfO;|LYPb#fM!v_h5!;Z~BM+PDimn^Mcz% zi_cE-@5qrUMXc|ynVIOVQfQjQ#K_dEZV0-fL*QWMhCWZnSl-8r4dO&QN)7)f%y;g{ zzn8e%@Poyebbxu~!&KNDt4HeqBNC3%_cNs!iOOh6;mqf34?gF^jF_-D17FzJ{6${p zg7M7Dj^Z4KzU&{*W@6hD@@?tGv3<5H=DL%QbB=zXnaox1RE#Sxd`I2fOB)XZ?JZ+LcXEXXeIVM2tl7nBQ|qAcA8Cp&rZ?eI@S%*`}MHvV?s;)nbc2GADqR!>Agx^Nz>t@miX5N?kA4L=zT9%1|Lvj z%;6CHv%v@tuHOT#$ZsvfbyPt#Z-u$c8#j3l~~m)bJ~mLCSxZJ&wfb&Bb;A0w|DsbD29 zTUTU20B1OE?G>6>-rq~zlz4PC1QU22jHj3@b4H=5Habp*9VQQv^RK@T7;&x==RIS{ zBW`69!*lYuRtMuwS0k=R(obz^F)^z+F|Jplc%csSi@ilOm}mTlx&KikcI zxB_Qkt(l=iesLf2aLb-n!o7hGn?D+0c*W=3iM^#)yo@}eM6>dI{;Lx+D?xpk#d614TT-RfUN7GMDiNs_bnm#uo zj67m@?w=D3)MYnu!(Zog^x!n0jY~F;9_Mq_I!-EushD}8!}JKg|F@aA^}HB^ro~8a zs}h~u^mtZ=yhZk(o&ognd|{Fh`ZEql=gd#RY@Q_<@FB04?V3Z7R-4?pgbix#!H2Nv@~1n@=u^NXks9m0WFQzIpcE3dtAUZkV5aE|u)q zq>1@P?{FFqGL*g$>+?Z2WE4Fipd4Gf=(;R`+ZCeYS@`*dHge0DqV|{o9|-9oqnY! z9vWrUwHOIl&U@J;R>p@K1)O2mq;JkY z=-->M!yu2Inxu7SgG?iT-;K{iwZ$gc{fzQ4){o7OY2fBRy`s)uB6| zq4lggMmw?gn8cr(9Ezi?6B4-xRjy23stY}J^62Tv+GjHN|2y?~25bt!!w`BMXvs@o z#%$}k{GKFosw4DxvY9x`zd9V?oV!hRYDn)8=lIJ6`|n0f_T}t?^XKwqO{g&0gmauN zk18^u%^oA}uQp=EN6t8Am@xLV36-Oa7+J=IWyI2I8;mG?ZA7zF?&)8R@V>&?bS>ih zZU4)VFd=|AyX`rD$0K6y+!yZdpyy*t`Yc-vnDUKTAe`ekZa2X^hg{002?*&$Uy2D? zu;kHa`yb*e#GHJ-@N5}O{^5D@3>BQAaBbcr9%LFyZ)(n#pCx9X`-cUXa<(Q3D-h(?Yduo9`?u-ZzuCPu0@qVl#Pm-AyiccalYJ zjxyzKQ;DA1OzJ#pCVkVJ%2;~J4cw)a#0qYbe853ErMpQ4xr)_Cc}ViyMpEYledy@f zKCuzAmFUwr`jLxFt*I8-&{95g_FFJhDHZ71U;P1pzpsijh60(wyuiXog>vUyp$u7C zD9(oq1QcLSPJvI< zUbU-Zhq2}W44F=^_TK^6`jh?$d;IAuq{VK>KwN$22a18QbPB!Q$iY(g^~dr%zSu;~ z+_##6aJflOcrWG$4C5@+jkwWaE$m~M8+}ZR9uET0u_b$+x4t+yo3H0X{ClYuuE_zY z8p14&7C~sJ;J=$Q=i#S6&l4>*O5lEXD2G8sC z0}3Xt{hRvRb@X~5URI$ZXT}=lQ&)+=+}-3nZVE>d`^Lx<#N>TAYyX>l@xWAMrdhCk zJ~g!isE;de!PFxbTv|Y^g#A$5Vqy`TV>Ae1wnA_!dNpC@263qc*Xco^qR$ZL8+Pq2 z=w2-q7oS+ryL>9<*yvI4ff~80#IHVB&~Oi5E1NTj4Dzh#A9w2}Ib5YvF@Ja}CT+Fg zb!&Rx7%kK++c3X}4M|IwxluM3AL57=jIp6!Q!7kesngA-*360j?;}0>Ij?v?tS+q` zb;HCUzH+YeVG^;3GW1}&YQ^W7tlnFy>H_Ixrjb*Lo)l+NiUe` za?Xm9Kbe(#(1!cH$YHFRixqqyNyPjwwsn$2J)C7OeWd)!Jv`B&g}f7IS$5b(PM3C; zzIn~$VUm;F)OyHZVi#Smx=1DOX41M0y-jo6WE1@x&o)=eIX`++^m3B9TyJl7GW#>m zN&akblLPnEa&MbbY(w2-<3N?TOi)S8V3jmK;zB)zr(`fU%zvt@crQ>%Qd~9X8hHyfDBH>BEbq_fRboZWBwSzV)m=0Mi1s*hH=3rq9G(hBI?wp_Vy0S_~EX zf9&IjgBIS~{4t#C?Pc`n;J#H zZ9RRi+LNcanmKhT%okh1JZa+2r%RCg*gXQ(Q;9uY41@U&v6{#9fNV zmIaoN^fA>iJFW_I8yfO+5q(ZpSx};t1*N!lQVZw<#r3qzkKEy8VrNCEs5hJ(W3G>Z zlZchJv!Ki0DR5YALH)g{C=q3Wdw*uue6wKN8@^6-D!d? zIoBjT9Os;8e#@j(lrvj#YBO=6w^rDkbMZQWv&cU-^6iOf4PlPwS#o{CIgdO-9*L6t zk=x8{iy`hk%8El-Jn$PDwI#VMWa(^qwfe3hTnE-&8PF1>Bi%NY^ox7%x* z6AH%qc)WbragSXS^Nh?-oq8q2`HZ;|Exn(|$il`k;@2r&X16g)9b=62YGaT}%$)9) z$T@$oL3*-(>Z^;BJ`G|dwca7|R7c6Fs|Kl1+9Y?{Qp*yZD7&$i z>$y{f7xW}qvPp&2iE2z&yJK=3`G(Zm?fsYiX=61Gu2kXc-^`7srlp&j^P2W*w2E}c zNcIzl`co@bxj9;XRw4V63ND=KSS>1SnWl!raL#oy$SWySvR7s%z(*x+^`y3@ggf@n zcE|2jD%AH^Bc(DmFr`EB@EzxLgUCnxOOMDhp~zL~;axWb+T$T;@rT-$F#4mg-#Iaq z{DyuZ zD)s0?o!>;(qyr8y&mxi-NCx{=_WBc9la`yJN2OBn7{)s9;Cmx%>Gb>GMhzr6Cc|0t zJwC>{+-=TQEk=yqKrI>Zt6#myW6U$4BmeDkjed@snT1h>wIA!eQ1UKzzoCY&hY42( z^5Z2l*zOxK^D@01`wl;(_<-_yP#d#h{{^(pkiqVG%hZyDGYlZotM zoWFgf2hG+D%wSD;#GZZGnoKy`i1U>ox3Os*UplU!`iR? zJaQHvXTqa;7TRy1r_EyeS+&c;(eK26`1$U9dZCfy)QdHsmytbj9%r%qzSy=u~8?jnqJ z?SR2<5avC0pU?X~f57_#AJpJ6m9!K{7;~5>tx=Fe9UNYZXEwee-;&i}M za?5*2z+#(3oMvAmg=fig1yU<1QD(dy^{zruAi*d(HxzcS=yN!OvC!uryu86$I%5>q zxL99xon`qBed zq??+^;Ter(MpQGoXZDh(6TGE4y_vEeE72w04l5OQ_-CI2mmJCN#VN4oWiZx$4McnH z^^<0V;Gdejwu8Y~uZ+cvpWKg2#vss#T28IWrwQXE#wn?dcs-%iXnf55_9k_%ZgQp~ zHXjb$-}cmchwsbY!AKqFw`9^<2Q`&p>!_;?FPU-JSDM_=%J)US;?Prxdi9j>twX)P z=?c8|Ag{NJ@upuW=9oe;`B?};9|q%wu|HnC3&C%54E>{HPSVE63*(Y;pip7cwj|73%AsCSN<(haDe^fDifBb&?9ah@_|mPXoF z^^&sZn@SGjfM%BzP){KbGDv~QTMCSr%d_3SB&shA!uHT0e6tHgRdPHTt3wgS>-lzr zj6-%T()+}q&-WN|O)+@4gZkg=EwJ>naMr+rBm62sCd6bjs;#FrZBuC>Wm-r!8a ztPu18=M#1ZA@42cid;gm{v?0*g=mbO!dU^H#g}-0?p=vSi!ckqQW#q@HnbZ-AJaM1 zKVVFHj{KtSCpp+&+nFMZ<4jT*c0m4kM-SogT1<`d#87f6`NPy0mEnnP z5gN``EyB|R&hCck(e9=mRaQmfq(P6G>#2jd)QAbsjrdqdJ=$HYX>OpG!GIhrS(63# z{W+K&mkrZR&iPf!!DF(NLwQYuKafcYQ|fM#$5>oVsq1>0T1|!VvVuIwIC2-24jmBh zEe7V5T8yp4bA{J(x~T^9mU!XGN>3EoQ|piS<;IOj=;yH)a$1jq0M-~jaAxtk2{reU zt88h)-(teDc}9f(q}JCp?s>`_?AgrxdTTbKUuR=*Tcz&u1hODx9(r|F{^yn1=o7WT zcs_rjCcxQt337RKvh1pzB15~R$o6-h*gS(8Qm@E4T-BiYA}zwpdSZjG9^v$qXx&2( z*9m&G9KHw{^XZSt>lmHF&n$y_h^MI2IN1o(8=fT*S$H>!dA%34n>KPUubzXcm9o+Q z0==ZjIehbD4~X@(J*+A2??*ib&Z$ovmn6G4a-LyYlC&R~B4vCNWPiLGsyG!CBQ@m9 zHF!Op_bHVgup{)CwS~MVYcvx!M_|Sw@`JM?K|&W>Ss(v!!Gr;Hvg#5ogkNTCY&6PiayiF$TWs>K6@w`kZFmscf3(*)uM;! z)?|5I$0V+uGORwBcS8;DES$k zsG5uwe2)IAU__XU5vwQWpi3t8$1Y~W$j`282G74q)VtbCZN}{i-5k9_H|w!NclJHK zc*5xa6xmn?P4g1_1|Bj>p^>Sj8q0taYALshXG3E<^sS&o?S(uyZjyg@Q&N{U7-ii< z(Bo1d?$`yR!Kz@?R)%m6kh*%KV=!$@45DhsV8#J@{pC<+cuWR7>yfAKZ^qY?^e{d} z?b`Ylgr20Ho>M+jr{`m=*$TB|KEjzxzFnf0q*fY9FX1k+={{2RsYaIlY$dieb|`mN ziCM=uClG9h;tqCjGBWRC4s^>D0%zt!E>o#x)IJzDFNUI8{aEzC2;Cm2vm=#5qT&GL)=2pbvS3i z9tGjnr5H536ph<=c&=CAoWd`1mdvG2f23a6AG{xBGw_jTeD!4N$-9tm{KJaQF8S2+ z&PQ458tprqk6yd;G3b`JB=2;Q119AlZ zogKD44#ted!Dv)S_Wkc*L#1u~(Ts<& z^ml%nj^N2=>f@NPowESTujk`5&oTdZWb$WP;mEu`(cVq8E!0xM%T>;CCbxO6x4i47 zm6OwKve28J1aXD(d!zz)mhg;kt-z_-!HD}DjLKvgOI`@Z?1Ug{jf5bVx#Eqn)aoC= zdC_z1^E$GI@{Bx17WFiXEYz5w{xb8m5WN{)3+Ovtp6AvA&Ph(>JO_0VO+I5!v@+U`-rQ%r?5u~T4kO{H&$@I!F(PNe8Mmpo;MMku3PmZy4 z4zASB#^F`jD4xN2pS#p6Cx=#_ymI67)I_{S4t_Pgv3QnUS$jaTQ<5e0szFu`CVSp4 zS={odB|r_4jos8Re$pazmj=PPS~&7NwOr9-rVH!R+@JUHdTNZLwjTFqAs^>+n`hV@ zBgT;({2os49WvI7o8+L!$t*lOl8w#W4>$ZGyBE(Go7dB&u2LsO3SGNB?0+02ua}_I z1yHxP-Av}1nhhwVMk8R z^>idEpP=4KiXL+Yns9To3G=s`5SB%KBaIO*r;YTqV~)VRFp4?ADb|l$)z5+TA9_B2 zRp^`&sB1&Ma$*Uk?lsShTzVOgA97G!n16b2;{4omYUj8ZrFFVdLYGp@;0g799JR3T z;E9nnyzuj(7W2DCVxD&-XOqY=I!2=9Yu5G`vF6^!gciI%E<8)WJz=ad-G~Eij2O;- zsoQkwXkN|6*oV|Zyq%3qXKKXrERE&04Ca^d3AKd}D|F`rl)AKS25A+LAPdSE{3W7MGLbmpPt|9!$*^!Bm>(MVCl?SxV-? zME`9oXD573=w8W)UAv8V`J6e>i!5k6Fb1+@q1&NMJUNz)qw5vAV(R1kX6$3CuhhNw zCmTz>nO74H5>9QRd&iQ*UYR0;{0yRbN8Yo$3b?^%cs`lW^=g<#b3WiM`zU|v@yBvr z!!l|e*XB7kM~@fnsh2&Hz1j#P)&`p}@HlmM#_%jQev~*N8@9q#45v)fCYkCyg)iEP{dLEYda+Wm4wF#~K(K(*8 z>Fvl+PtC)Ne;njvI(5yu(u;_-;pOCF8vSj>!dbPYO1WbBHjkbtE6LYHaJKbta({6i za;!7;dY6*>TOEysd(z=Hm9@`QCvjf#OHMrVM>1<%Ef%FCdtDwL`!^tyuE1C7ubm_p zIbsy+xC_Wb=lgOv9YF=zDDk{-;4TgodZyOMEAgqiREp)UD2Z_YI=X(Yoo|CWza0^zrXyy4L_xYQ-T zW^xvfAnF?q4x$b!=dk;yBQBc%u9YeY%d|L5meolSuBDEIM&!=(#++#K&;-DGtCv#?CZXLPfS1h`s0A!{`16$1SKb{Bu zc~=Qm^K)0Rui_sKuRqiABsLexGhF3R5;?LzsYlt9|6Ziy!yMKUFR8?SPk}sb6olyy zH(|-DbnKX!2S+!R94P!LPOAfO7u0J=Nk`7gJXEOXE+xtoN^ONd?o9pHH#{Ait+{yA z*HP?EMG_qvh(#6YQ+z26ZYQ`d`ZbU~-Kj%Y9DqMVqwt#itU;HDm(Y}e|8SW4xY8|_&hiT(xb~=Jnj>bAJ6^I-V81#UH=i zq}3V)qFZy0@oW@^J9F0LBzq*YoaA7AdZdk~Uvoh;{%mSS(P#eN6|U0EL4k%F$V+O- z@tvce^C`}o3xNIGO&EKH9P3|J;A(55A*M)u`fBU0ME6(N&z$?>*Pc3=b=so>c&-<4!xOJQQk1h?wR<}snm88z*l_+{rq;uvYkN(xvWx4!YeC7tik^9(} zU3{O~^d+C|A~S~;ilrub!y#N3hBSmI=r6RZfeiOjpegssYTct?Y|glsJ*J_idNO=c zv3x2Fz*6dUJ|`cl8XR_rA#*`15cWn3lt?r&+MqK@sq>!@!!9<^d!evOONC~K3p<^Xi%>%W;Z zbYp+3Lo)g3=Y^7A*bfiyQLpw|I@Wpd^DWy*R$ecZF)8GQ+tLr+)rO}@O#X|UnmuRvc`h{EmWg2x}UjUL=SEXX^VUQagF20kf-d?jwOZgI~yCnBCFBgT9j080%fj!se#T zt8@3uiT7^ULSI__8u}$X$fTc+LI?6k@$~tfl)n%){pnlXl75NIzh^&Ake@{!m=i`0 zsCyDtdC_0TU7^eQwqIhpXt48F1TI}8k2Z`m6>W6Aw}R;sm0pB zbLzoep*MtMIOe`dL}AxVIPl*)-X}?}w{^$4fC!WwZa~~RYELm9vp4ONT0K?BYY>hG z+mbjtmx(jv%j!n%mx()6X!VRxJI&UH;TTE_lzX}IuvaT3RU*Nwv zi}cBcCAxU|(&1mtbUk*pGGIeA{hsP7bZu{vr&FpC|2qO}_8Q^XlOCeOY&gwz*Mra1 z#hVN1^OXe0Blqy0+-u$M`^1GDaq|3dsJ0|wZZOwNM;q$-n#6jG{8Ap*dp30y-KpEi z^*HT#oSb7{>5V=DRd|2WYh^Dz0sNMTDVOPS+Fqec(NUMgNsSa&J^J%`vvbZwS_!Uq>X7vQ?hd=j;cyDz za~R1U3ik)E5&LDuad*sXMgI2zUnjrQjGSg2a$k#+RT%CYP7hTBd`?nV|B($p3aGa@ zO^y48aJ+j+pIDcBIK{lAXlk5v-Q|W)4I^-W8u{zpnW*yBhUYgDrH@U8auvv*+LExz zmIWN39w}a`=gn$U!0n#5WSvxF?q(YHq^U+T8s--5@dEWHB#F$Z+=X_c7n_l^DMJ#hC;7`CLapH`om{mpH7Rx435x4C0c zFFpP&M-KEvCc195;q!w1lAo#mPkX;-H=YX}vXR)-hJ;N<$+aWrPM;gYR0EcWa9tcP z#<;cd@;hIJmDIhpu}^1LBNHS0aQ`0`C(21G6t#skb7FQXlmRPMx?=?-zG1we6?< zb^SVTn2?%w*xGjRA*a-f*Q@%yN?7YxarG>}mPf)a{NEsoKw8sXH(D zwDtDCl8U(XsY~8oOg(kjcIs1hMZXDadZlK~n43D*u8!Zk35gQLI(nC2lN`!1ileVl z^kfxhFxQ>GJ5JP{OmhELl8hN{l#F_bvT+vuC3YoB)yfI-x@(dgi(tQ*zJr!$31VGm zl;&NN#djt3516|jm}8W?XAM$gC^b$eQg@gvqtYW$j$C8iKFcJ}Es1iwFj07hy1 zBfCx{>iT6_70*s_-2jcDBzhGNGQf{@_y%>2 zaQ=fji}v*4c#}z=yDSuHva!!82i_jph}l9WpEW6a)?9ksqBhU7EX?0bEk@SvCLYR0 zdq?U=uznVICJWalW}!=77J9H|m2f8;f1k_7jePn~kD-5HJI;Ep$U)7g+1M38ZO2Qj z`*FP&GgfOD${s|cY@|4`m$aJmyjMJ=bji9h{5$pIPN~J((_IE=J*4YUSBWa=F2{B? z68Agq@=ryT48H9y8Ry-k-sC1yGKF*MowO2h*IQaU_{i+7&T?`ky(FNL>bIyfH^x;u z%=3_PZ#*S>EqSc59-?&QjNW-?nOmM711Gf-a91TseVK34L*Pq}t8AU?EcJI3%l=ME zBn(mF?SAG*Rp_xmU)y=UN{p+iL{K)_s|Q8$_>%%(l$?q0ZHE)vl=!P8`?D*4%ZI88 z9PXsRg-bp#punDA3o}4u;|6t+v`^ z&j;3nqo`jupI(LEf6I2x%UxI4Ku_CZ`UWsJJ^Pkk zwfD(0szZ>>p7|gT&Y9+gpo4E9CiM!&`y~OeR3_KBH4q_d=~>;4d0(3le5u7c!CKZR z=7r#G$zaUv$UeKCY}L>pI9h|yv0E^zP~T`(2AMAMkKM14Ma*D6QHfeYUYw(!9fOd{ zF_?Zj8a2C6dw_NO%}Zht***pLy%{MujHPsIxo<8@^G?F_moM zLFP)|>47_rKhK|8Uy{9a3mL0!(bR3A4xI!4&OY|MnPjW(M5B#;EOxz%#`$gJwU*G6 zx1j}_zNX{SgLJg9;|#9R0(&P5Ua*dlxrsF|{#h}cS_6|U==I!;CpXfORgN|LRu;Uh zN)3QD)Bq@Hfj{$|*sEqNJWX9DzFz00nXE8*#r9@w7-UA%+vKs*$w{7~FT@ts`NcS;jsjp(i-^P6U15>}KBDIW0S*h{E{Fpr@ z-;!1|KE@f^`(&+tu`WL{AB(?Oagz18E&W)7xk^6kLOxoY$j9upWU1H_pRZvp-;Ycc zdmR&B(`PA`Gnc2VIGREI#}9d!oRNpmeBUd~c}v`7Z~wPe6!)Fv<84nln&B-uNn{=l zddPZepw0+uB#$~Ymdaf;5@x3r{j>)1sJXlB&2Sa%E44gPs-&OZMW&bWlETlfGH9_% zzEY>+Odqwh+~_T5$tpT<4m4#rH6D9;$eQz7sgbIZ;AI*a*UUrm`QK%iddSCDE|N!{ zVBX7y(sS}}$*-h9{a7-?eeHnmWPd9bNv1)8ZuWNMkvKEFp;(^xSE6kfB^I%-w(*Ao zhkn_ljgGpdR{BfNDwK2miljF6xL$I`^7>|*Jbqs+$4bQBFA_l3Xi5oGmc}uvsVl@a!vlbCe(Fe zP_qix#{4DalRllS)jf;i+Wj4c(fpqJ0a56EiCRRT}RBJ~|R(SM>hH6F9fsDIduQ#09vqy|>G?d+{B;JVe3^%%o>mlc{cXCGi)UpQoXxus zes)!#xvAyTeA~SmS3cDz$-!^S+G(k0-`q(ZWE|i2ceXY4sl%=|d)x=51syJR_Vw** zenao&`*olB$gh>6Lc1}WU$)+x=a5$7PH}3(M7MU^N;WuqYwx+XHJY6`TOq1c>W?uc z{0x6rPCHoodE04g8>hAWdqmqa&#tx&t2i^YRn#HB*JX~iIiT2{dU(CH?V)gk%&Tma z;A+VdKExy~FD6Pd=UJ{yFv#HN2GO-MN|z*qbTB7MOU|l}xR@mMPN&HC=p<3SpHps5~MtaVhWYH38AKB=4P{SziqD&H} zjh7cYP154BQS2o}5+@|co`Gt--k`;^^7P2sNZtQ6T3nq%4>;CR8oy*L$KFf>gBEqt z)I3Yn$epRh+j^YWi__58mU`U_)yR(0p!QfTN^PSy*G?_9^wjt;N{w-WYIK~W#!zyO zkH4wW{BJd;vqrFCq82^dYY^wG#dX$B4&2e=UIS`aFyDRkC+A2#$aG{=pSxQm8DGw` zjts|A1$mF~NccC`W5F?MX?aJWHTlIDFV63^rWW@_vMBwj%gFdo$KGCT<{2+4ayF(% z1ib!WjJThgS8Mf%n5BnXFZTaB>d8Duz~`zSEBU*Qwa{bkRO&Mx*JI>l_D(t97Vkrj z<0`#JImdhUXcFcX8Ij>^!v5h#%maIt(}*{nMH$*=X>V zGoLP5xcQv5xt;74j>>_SF=1tU>eh6m?nk>EykZZr_nK_XU(Na4Ls{7HEDPWGbBoOE zF~(&f_s?t;tmjPH9{O6(%)!2;I~FzkT)3YxK366^LyYs6{v+6!YEbSGK z`B_R zV(LVmqt@=9894FCOs@nBtZ&RHQ$+52j}`A0GUk|(kC6uMv(E1@Y?6=oUExg8OCS2q z`p8I!#?t$bCQ?|A8s(??dF@r8MgyMjkv0h-->7=TxtXc-=xjzG<)%Sc!SlDFG6(}5 zV*lemjy|RSpduExgkE8GG3d6J`U~V6dhW6S5!3-DKNHK(&-^wYyPM}@PTV`3983?< zr}@;hrcdT?A30ahM7HnqmE$F~;!&lAemyax=O=0iGfw=;>xx#J zF?t~5&s}5~H_?;(XC4A$tgz!b^OW&gYMCZ-+fO5@qna_lZY({bH8Q?(6KQqK4*NTl zK=YmoOf5k^B~QtHLWzqzL*aBM7zIaysAUj@BWHqOcOn!&EAm>7l3%RMIU~jmop#1x z;xOKy{)|=m88yCTMloaCNqx-FkqMd2-e=WL`Iy9bakPmX>L2u*=Jk~9azuP~8^!eA zBzbuWvU+2pbQxoif3|6HDTSMhn1 zYtN?E>lP#Gmtu~3%7DQ!+<%zAMug-b=`H8jSnn(2oP%oI7cTl|qXRuv4D91;$$jmA zP2VKe4i7w1=$!Q?DVUrhne?LYUU5La9Z8YTtTn!TsfBZh8nz~$DEUImJ`*((_Gn?c zPA%MYJ^b3~(QiI^bS1Tu@DW5BxW=t z(9F5SN36e&Am>>?y}w=5Y$BU-{#-UZ=2L&G!vAPjmj6O#a5PzvKa{$~yGpxyS&uEg5X$NH8IHP>osKvUb{G3{9FtDix z!zc1tI_ZhAw|OS=Je5}D|A+DUabZ2OVkD|nHo@(S0j@l=7Vxa=Jd*4w>yCSGv3}e# z8}gKXFRjT~vaY_fn6=jea-M!lT`%5~W$ZWHeyPx1jvyQIAVq@mIa6`VAPu|{ru z7S}V#(Iig<*7L;OI%GgfYyO+Hc*FUL^}dmqIgwhCWypfCRy(_WBsD$A6ZJNt+Bb5H z@9A@K(TI@yoF{EzK(AP`o};N5*_J$PXf~?G(bp=GXBvAC7jG+c3C9(>r@IuoL*!GM zA7kId!$)R5X(Fj*wbEt0yIl5D%dopz@##Qsh9D)9La7ZqU4gkt%!e-9q4uH>bovqu z%O3hnGdKB?7l?OX={MgZmYy5ToyU@aKg@i%S`4-~i$S%O7R+BkKF`mBxBV=b=$(O4 zjGgB`rEY&XHTAC2Q~7}v?F#bn_6`|lRTJsi$y2&5p?C4OhEiOynY4bamTGAV&JHT! z(%KHeDm&=EQY&^IzxsrrpluLzk-^Al9E@tELg)(-f?lIy@q9ZOIeiS~ZeyO_F9r_G zLvDF8R=4L_I@f~7x$KcvAm8|iJ_e&XdsN{aDl!&7NKR!sWAv}TxDP#UBGaa6#BHjN z_>O2QV;47-sdc<$9rMIv=k3sBA$iZw3QXp;%rq%cp+*S)>=c4B$ejPlnaDT``nSwLNAh|~iy7msX4E*!UTacKQ)qoZeD`Iy9A6Hg6f0z=&!ewxs$I2&s{C_=_cDU zE*&1f%y@i19~+Hi&6$f_TxLb|Cu&add@W&WEQN2I%8m+6_v#j`+)0n}rsP`MvSu=j{?5l)H}PQ}<;48TpL1Q^`FSOg|7?Nsa-61)b zt-)YlEry=(M0axL_XaUH8KcF>x{+|}7m3k}^wcDY#4I)Q3~KH9XiUgGY`|uoUDtaU z$;TSex`YYCCekl>Q4Yq>qDJkyY?Qph`1w^9URv0jB!AYQeC4Cf3S9-BUp0AclP^)1 z;2!J!w^Bq;&4QV)k|ld)q70r*KCdfl_;0n;vDd)<2=yyhd!kN2BtirADE*kT0lZf; z_tN8tXRGOy2~GN$P=e=asLF^*oX0xUh+51wb5Nok=hK^$!GFaW_HyLC9ka2C=lY61 zN?qj#yhrTUp5t{rJH)ef1^X9&9+&Q($uh5bvZOm6kiRP?%OV$Y_=i2A;yHTvff{X? zE4E&)hT?rB%#WBiH6#zPPLG?5sEbi85_|KEoCh#rO;Z!n9GEw$O|a)a4W8#q|H#4J z1fCmxIZMxLIcFwYKwt2O6BW8+pU5%tdPeeG-ORJTU;07Wnv)_O{^7M07^P{@A?a4> zptKsPMcz6sRxbAh`E%@~w#U6_>i^7)1o->)Tgbmh=@C*Kfol~a5vif3KI`+sGkx$g z*8680FiuIm#vfT2{)Rox<2)&R<4F^^gxs};K5E=pbZs!E+l zqZH}1DMi+@KhtJhvQ%<7C_eM4VcFOV9||;BK2eP)%h(rTPF#3Zi~71qZ2ihU#9;D_ z_w~s0ibSW9WI%6_W#m_@sYcwZM9qYs)O5-wV|hA@n(^7_(lZ;Sj%UHpCmYuD^iR63 z(0%bx>Q=icbsfk(jG4)M^yYtg#w%ayNSR%~sj>o$)MlpD9(NNbP;{O?~*#sA9F5jf~hn0!dm8{;tWTbev7

YmD()?v zsCQP+O=^#_Nv-g}|E|YrnHeW^R%+xs$&Z)C^2M-Zr&P% z_4ZN7vu7Suhx2ttm6+C1ACUerKd2w@DUbU&&sc38M_E0*Sh7lUE+Q@p_nUKHAJ19f zM~+giE;+%M%tL!}{`o>0JT~MZlfL1j-~X0HJl{i)lP_P-d4J|n`HkpHTlu%#b)?^u z%fJ3eX8NwMp8c|(jAlRNqcBe4zO8M@dfrYe@}!3B9c`0aEBxU(oxa|UIVZ^a*{|V_ za+&&-)#&3~h5dmFXVS3ud@iPCIZLNszr^uHKinr*mGe9eOEdGRSI|h_S1yoB+xa|n ziNUv=G^nEU=zr)aP6-9_!zB&a{KkF9nD&>t@fnH%Waz}jfd zB4=3>SRid8g0S}x`CQgePVx*M96N_2Z1ZV;(9l zQOQ}K0y$HWwfoYnYx||+&QtpEgw~c$zl){Y*+8h{3p98xS%X4djq zAMduBTH@WTXtuyv_PnF-6YsMtbp<+BV4eCO&cV-cmg7CBsgT_dGx>aeUSmd5bu0eL zX(;oX707(&fdAqt`=!)NP0Yig$_>Q((=Qn~ED%$<|Fr9yj9Q$*je%pTvF^_rs1Q>dS>OMe@87eWX6HA66zEFFIIJ zrH+fNx3@_cHBFZGpti_l_MevJaaPth)zu#_tkgicOT*vESO(r3A-zTaJv_ZNvLy{j%CjlzU_^tGQ) zzxclH62pDqoHhXC8Migyy1T)i(+cYF7A5}{Reyg>8cn^|_US0~Fb@aw>Pyj~U-Fjc z#nFB2_XY6!7x7&9?I;y^f0~27RCS`D;Qcvs=U@KXP3}ziDdkwVyO_U;v$pA|b|V*u zvZ_gjC%yCb2Elo66t3+eAI)51a1&2?Q^h9J&Hfn4{p93e>S@O3;k40F9vmr@yHNqS zNL|Y$k97F(dF%c@PNr4xzoF*SJXcTZua&ob?6q^2uOc~3->URFqW=dQ$$v~; zIdcTsdK>WZHFfch(qH)fe)*>JK-~%9=-k(UmCNp7eiMbR(~vm1Qd^C3`4OlwkN+;l zq1%TjblHq~M+d5Lxf5&ToOcP>k%ff@8#VO|QaMz| z9|Pmbzp4ASEE8>ObDqN?PPVjD;W4?t=>rUyRGsk}x!2IQ31VL2&g&#M>R`YN2iB?U zFh*LRAQ`^yWKF_wu|EBjSl=4ci8HZ%ljLke`utYr_1sKCBR(hX7*}mii)VTUiFNk;> z22;oIc};iR_YOy3EIGLEnaK2_w)VRO*+D+Bn7xf|JIGbd$-?pZHdLsZC}XR8a6Xbe z<}~VS4Wtjp2pc_ac8eRYC!7A%fAMpyx*&`3t&N^M@v=Rd9M;QlY~%ay*g)>DD|HFq zB}#3O`wNahGC!~N@tLd>D0J1!>=(QD?&!8rxbUtt*hnd^El zH5yJ+FY@U=@eLw3s#%C`Kd8T%Nqt6gWcso3QmZX>)ySh=c*W;oC3W3bvfdVHl=?s1 z@yFYR*!IzY3(kz)In&$yd7|WpyTPqqI8L5SLio>2`d8YJRf+W`YH-}09*)thsclp7 z``yS1_Kp{u8+p&x;mE3Nz={|?|GVg;O`XsguRP$KrALV|Nw^Z6g^XqjorhPvRJ+9) z;F_GVok@OnF1eX8)Pbd6ZVr91FMXpQtv&TsKXYGlA^*EDPG0( z-MJ*hC1>K>ZStq&tY?o>qduS8)~?jRXim+F*ETXq@zQRD8Wc%^V*?|qRLVlt6i-*^L^M)O)R$gt}o_aC~M%-*K!}$8aBr;y&4#UIBa_g1Db#fV}5W zdbu?V$H&9;dEY}_*Y*nC&p`6v%;o-2UvI*3?;> z&ZnYR@|l@YyZt8Wccli8m$QF8oYlJDi598GV@YR=N7qSRnOq@lS@{ZSOP)uhmfl#o z-MmBgX~E%*QxneUQa87|bGB*5tJICft5eN4;-s^I?DhRbd9lMFx!p{%WiHQ9^5iGz zg|s{@UTW(T<-l5loa4RvOjhyaKZ){MMLp%elcY1(+3JQ#GLk+I$7Y&jZv(#0vnTCD zqMSZQEgsG(j-z)+V!ly2p5bS6$|(Nf>~nLy9U%KVoqS`drSY=#6uH~J2Kl{`{?fi` zJpPM*9`uKf{acM{Rp`f1mVaKLX9R0E4Jv7|HJrYHKlnKx<{8TU;vCP?s?)S^DZ_eq zX%+T&QseA(a{j$Jd&ru68`f6hm(W+7v;CO^RQUOWULpOc=hL2=rvLW2tEf>rNke@m zYS_->xjB~FJ_%YxUyMLdNj-c9kT)bdKBxlgLS&WaeT~4TB5LEz)?>?KKFd!c;K}+? z!5jJx(wn-|4m~|_ijqn=PJ)IhK2N8AIs@ANKb&sxo{f%G6e!}nmndc4Vi znR5*AzQW$a1MbIj4LH=oh~>MTRG6xi1H&1Xj7khkBoCp1agmN zZ=h`m&$vff=&7Mspp|Um^=$N+$9h!lY|cor{-R<{i2ID=6MDV#9GicFy{OzwbYk7Z z&@>xiWY@p4Z+%0Th1mY|ldhkQ_`n=`xR77W%0ef;=QYN2-~J+VzlZz4bZYgme`GC_ zg&H%c#~hGNeNK0AadMWb%p1v z@U;}Vs_8cQP1dk~k7D`mset~iO&sitq)A1aINr8NqjpLhu0{`{k4jvfT`V0rA7omg zfUluQwptXZN?p3OWVCd%ZF1>ck#smyELEr4q~Aem5bUJhBQ+i49~R2(Z06S`ilxL1 z1xf@2;kt7W+;32igUc!eU(p4=ky49&_w&Y6>? z+C)tta)<{U>4DTL5Zgxvq0}CKyj>WK5!-?=f&63h?E#qQ5rlxGAcO@|KWIS!u6Cm~ zgnuyZ#dC)2GUv<2(igE$AWq#2M!k5>Dn5&ZGc=g;ftjpP!8k9DGPmo}RuIVtt91(%*N4?9bSYFawf7tQ3DE$H}(9?_Gi+j!WFUN_TGWj||O-OL!# z(E?e{x_O|5^9Ss|kmI^Gk=jVi?VbBrFyx^btAd%IZ!u#jxvl!=%xKq+HTMnt{mHBo zT`}W+Kt9%ZQ451?VfF=jSp_k-(y(68o|JtYr!PFZoOfOEG) z=wW-sifQ%PXP%Rfm4DEWt1fkYSVMWoo<`h|d>lK+?`8ja@HqDDCsN1p2=m2hdGO0( z-HrW*Q?uDC3L{I&Jl?J}dsf5wy?V|OH_%9rnp#OM^yci6i###7Nyfn@^2ndHw4SbH zGgtthIz=(2ydDElHTkeG%_R{~KmgtNflTx+*L==pvtGJ`Q^1--TC5C5I-d-^9i$TWY9xJn*D z6$Hn7tEgkD@P^X}0jtueiACQ$Em0%z3g#9)%JM$?*n z;~LJs^Yv@p$vpmw#-Nt$X&#Sej>fg-5QDVMTuUvZP;&`;jI8&Zs}+OHsA%+F5RF~; zspEKq>+vT2s})>Jf78DrJqj0nxn}?3`&;;4L#YY5G8%6d@oRkyUbE-tbT1v9UU6QO zeXa?I%&0kzHP`X1-&Upnmmi;fOFCw7-CZ7K#>j5`Z+?&V5q*eQJBk}?#=L*1hZ?{& zWae5)QAhBb3JuGZ^7v2W(;V}+T9ZR zX7J}%th3^08Tv@OkyW{u$KDoaRX6A3RGO9gdR9ChNbjJ-oSRL~!--tJ#&w|FX+?G) zu93H_-zco8^pM&ocex&oc`!%kK||iL&3nF{L)}x>=KJ2WVu6Y^`kC~7=Q>@-9@=;{ z*VT0XZmz)%d=KIGT`a-+;I55+e|TL=T~rv5`d6jhslQU1rJX%!NPV#GM`}djnYIl| z9P*o+`21{}@PO12y=$ip*xKCBwxYt>f@h0U$CS!Xb(&-H)A%Kwo!Iku>dxB7&jyxh zm-=ORg|m?_Yp1?hKGg4ajmxQ*8e3B>2NTZ>DqNH5e$zSi&5P92UoX{6J+$uR8HYy~ zQ=1)JmHJ4TnA&dk@>JJViSnRsyp-LRB=4rA$R$mZEObkj=m{oSeLYFGO-Yp5oMXAm z`6ZvtCh^^6kfIYQvTe0Ne*9pZ*WD;jbxAUONwU=D+)MDiB$>F~Bp?1TNo+fVOkq42 z{DAD@PtM8B+%Ny!FvyKgDKgI9C~Ho{N!f%r33D(?vexJEy{m)hdKBmYlat zi?2P@7%`p9VWUXuD6yX@k+}LNJ*L%UDjsq!>xdpxDpQZ-oSt009&aK!>(`guB6G%q zkKuUKhqI&nT0`ypG4u5Z+rk-{CX6@7k)6>pE@VyW>oz@lPG&8Lap#0ZoH_i9IvMut zE1inKknZ8A?99CMdj!Uh(xc=zJvK5{yE%n%UJz%+T9Z+nK`(~o2E5zHoPPs#{udkY zX^0W_teJh`|NAhBUK6)imnunZ?qVZidm2#gG1;LV?7uqGTlFDxpI=EhIn;nhlc-5n zjoge6c^NOpjBUvAv^QeJaU=H4rKb05GAyIWP;w45q^=30x^SlER3V6F7j7vJb)y`#Ocf}kuWe-^OJ{yZxk=Yrag}v@%8GRXZ?&MrDzwh&GYCp2(7PT}R zYpVS(&*+rZM2?s95<8`*$a^md+v_RUuer*+7u4%5vO`2KC9X7MPoL+5KPbo@pEG@W9oN_6O>z$Y&|4DF%7k(UbS*zZ}u7*91R7`p;P(QO%Z zzqc^X+epviwLA;RwLe`HgCuXpdNpFPmG@)`W2YxyEl6`BtIj>U*$48TudImI#KHAL*A%h!((C8TIB=J6dXAH=*YgH9$bN}RZRJ6ePx&<4y zSm3k7Lj4PBS_WG&Wp_R`$r&Skrx#@?*-sny>e*UqANWZ239Zbj=_U6bXr;*kl{9{? zKqIm{Hpdc}c1nRE6Y2YEQvj7i@a7pgkS~m{BZJ7h1z~9WAoi%JKNb`XpJCJ_9~^@x z^QZxKJ{o(;TU66q;C{x!Ib{nzE~iewo(#?hSz+Ik{Od_F@#F{}^6QFFx4U{%aqg#; zK{YhuKGs{thBOfeeG@sBqr`wMHc7g{I3}L+Q&3`slA3KTL!qf1f(=(g@bq>Fo^PVh zD*2Q(EqM(WqH%#|_~)~HuA5R<^I8nvwzNCufd(Is#u0b6>ndKjmHQopUd_zMDF*%wMm@G3VsIvzqJQ*C!iwD^bhU zm<4CDgH7GJAFO2!iwu~G+{1L0Qm1;Q(6u^2O`v^=(!DTQI@U;*FO!nxL)Qd(RyA3o zR%mf?odzd*(1$XH^TXfNxW$@+tpoS*R@B?#p4#nI1m3RFV|+dOJTs4;!@PI6)rg0; zjCd4hfW89#7T-{Bwnh$CU1J_fjiRK6IVhZ(gBGl@j#!}3Js=l%y{AG~{(wT)fDFWv z(?;3oo-7XnO!U4;lI|~!obNHpiCe5IueliUiTmvC2lPxxr+$M6_whC4EvHf+l8j73bPl}_$$7qKz4~89gxZj= zv`XFoA?>XHn%=|rKd?nTc1uZaAS!m=*Ywy)46(brj|yyd7YqYiscqPCPzJ;9B*h9rJ-n`=#*ZsV&Yobn}wp+{NA>VkGeojI3Zi-4dD#@FUOJ`?# zY0__bGquUTzEcCK=7(M*e395u1zc1jfyd~#^)`Z(tv$5Neo|>9$EIvk_@eq3*$)PSHAJd1&l0mLA+Q9QvpimED zUE^8fgR)3_P%PDtNay^6ayP&r;gKfk+n4^8&MK%mFHeFm+M9i#AU|kNE#@ZA%dj@g zSgrFPTeKK`pXd;?%!pMNn9oC&sN_f!sx@X$_Xp}3``LrJkp5rCv#{j`^BxXo;bsss zVE3?wF@*ib6Hv_ywmF*>Z;szo2(&)a?JS$UPYH1`Z(Lm>)U8Bwx<2~+R! zST2%h8cp4!b2bc*v)G%(xow3){i#r))|27+*w{|}Umo@;EA`kZesb&!*}*c6Wpk>Z zGqCH$cTUld&!2UZv`}J2?F-!3QDJ}B=a(nI5 ztw`s-u;;2KQm&w>-QwwxH5U?$0^)Oy+!A z?0Xi&1L$?k_4JT=R-Boe2ft-`P<>*qz?A0F?RaCUy3|ivw`nA6k{gM>4fl&niey~{ zd(H_Ydi8iDfDK1P9C57*ML@j61U4=9t1IKq?(s}=;be$tjs6Zm0-WIJpyvczqe4J zZf6B1Ut(Tga0r@r8i4YvIkz4gfN0KPWjJ@0;yF5-6ph9gqY;+JJ)V_(rHS{9g5H&1 zd98RXW!F$6$)bkRi1*4CzW!mx^DX+;f6BuX){Ad9^pm2h)YxYEv##4(^!uAg0<+7X zc2uC^Z+lF<%(?54O@`g02b~J?P1Lh8)-l5Ax_?YK%xC`YVfGI#Hlm7+zURRlZ!*cdKc|mf3K_z$SYdJ)MP>iCm*^=lGYVP=97k#Kt=JCe9a|`Y6=Noeffv$Mn*cBn?j*#hJb+ z{hB0*XANIWui=9+y?o%sIc&0uwLJC;oKTVToU6mN`Si1S!Trq{Ejkvl*Xtm2hB&9L zF&UXFVnV4YMi|*o8*jL0d*|kZ-+Q(6J|^o) zrZU-6hYsuM({Yw_8TUSCukuyNgwUZzJUdU`vyKS|i?h(>X*N=`>Hq$g=f^o4Bj_<4 z#2y6&y$5qYDb$a79Nk&-oIaEF(@ROB4l_yc6qD5NktFXu5@fVBQLHCaa4F%7Ps3C= zdC(i9S*u#W<7xc24q>c4KAxe)u?jkLIiSN$;asmaBAxTY;ua>;qAjyky-A^bI^o4(_3|#2fxdOfTx)8}t~)|5dQ#I`(q&kYESVJq zrwMulHl&WVf*e+|m)O%!t@vC3jL#zx`Z5isQ1;NqdCNQc7o@deC;XQvbZwf3xX2u& zvS)i-r$Tw$I0$hQBXQ?+8ro5({aB;EZA(nTf+BO z(Id{@g7|^tyzV+nRYShinIC|?)0nr*{Z>dr@_L;eW$O*j$=k`t>GTMvu6>w&y!%hM z$>C1L^2s3xXUXrh38haTkMqD*H>t{`f;!Kc&-*441tH{{YUjdbBY9GfVsY3IfC+yh zq3=b%vx(dj40e$rDfC~vK%Q$l^?AosdJd8MEAJ$chl^!S=>S}cibTw_G^jez2aUdR z@9x?p&@Kpd9z@d1o%znmIXHi+j@)})Am;o)OuiO{>LrPSjmh1V6CFW%_t14!=A%GIq*JS zS9*Uhl!H}*FuERfP-QBr&&!4WKm#dJxZM*%->FbaY!ATQ zz4UP#or(kGo67BQkr~r|%eY~I%nyyktvqtIE>^^sY$$iR`NN!L-k;QnfAcu6lk+;)lU!I!)|dJ*|9x;Y&IG2hN1MN|+C`$X3#1C`Ife*5 zQm3)jQ8fo{dQT}isZj0=WR1v`eVj*A(d|(V-mGsZH3$EZBJzy>J);rZCk@q?TCuOS ztJL88uQjD##&~jY+BC!mbG@XaU+2j}X*`|%{sW@$F)xdPkk}C z&`)p`bD4{IpL8S7>tw}(AQySXdcunmfq4Hl63+jm(l}%~=63SB}Df5%k62eOP~LU3p!eHAME_czNmJ(2KltW-fLzn{MiX zLb3D=#LWAVcuIaSX=yH^f?cKb>>_E)^V4)kBnB>`SHRv}9Qy7gLwXiSZRXlPnHt56 zUJG1va}ev_K;EkJ>h?%8@%kz9NkgugkSn3r2{X{;4N%j-!w zub*;qUm$y!cwIRD7$@bRR)&-8cwZn-j|L(lKN77uzSXHm9&@0RY+q0yD);`F!~5Bn zI2C%!2FW1Hy_(wKcH?Q=2jo|}BGT_{^Q9*+7Qg=ys9C-=0X!V^bX zB}H;!N-*?lJ@(w9zvKscd&IcP{MLmsa+wAp+~*d9f8fLiOY zPShqn=>NYYR#sX)5qc^d!?qj9<7ePc2^)GHPn0{2y)dSh7Dp=@(25#rW_hkJj>gLP zY2NH%(IQPl4I=p-zENjbdMsXguO}~dAsn^bm?yiHHTB;%eA<0LvZl}<&^-(VLkx(h zNlk#<+`MiH;xIu8*Nya4I+cjeg`PHa!z3yllwcNxrGK zH@V7ibe&2^auRN?1bxFH;gVB4!4E|Ox>P=&E$QKw`blbk8@~fIPUFEr$bDftj-Wxs|wj}oBhm5Gn{ZTQpDAWc_$LA_!jMm0}_zdieu z`1@{t7AM1=ctZ0}7|gkeNDU%~#WieS&p4^H#T)8~FwDQrwN(xJJ4M)#Vt+sa$*=TI z=jXeS53P^|T{{~hYRAgj=k)mUjKF}U?4{jKU$z2ri|W1NQAl>CT{vWFBK9B8z@{_2 zjyGc^_q`Vszr(TjFmshWGLYoN{-`AKn0haiIu-%Lzx0pu&A^mK=vjyyv$>#MzMt*=EDpReUa3lQAs`XI@((ibrRn(2qQGoc?89;5 z`I3HoO~cTbY)oO74D_8+40A@TY;WL+%-X!qH`2o^g`66B)v|8!vNDfr^0xE`Oh|-< z&z-|w8%F+&m-t9>ZRA+zyBd%>j``qydES1LcdO%#bT@v^3i>~+&t$JVeI!f9OPQtK z7{U8L@09_22eIZcnLOi2=8U}Z!pFy2G~n7<(#ePB*_fl4Am?6t)3-PbickZ#^FG;< zU5vl##>vmN%n=^L>*a4CYmk8k4fuSGjuW@N?4hG?MK$i1dK6{gW1K?0@egyT-+IEo zWCXso`X65P4fV5g%6MrO#{KDe@~wQXCppu{@P`fE=fujdsh)6h;n!WMgVoK%tcy0J zohHYs@xteh;TZXg=jU?8<$I9Xa(|-<(|!?edXn@H!;c+_c86z0mSU7`mDh zFy}peWBL0ACLWLlJyH!ovGOxy^vWW6Y!H_&lLRtZbRB!gF&NlFlSz!5sEh^Y=Xfex2j$WqU1rjwIs! z;tb3mXG4Qk`=so2Z%j#E1hbC3dEz~+-)cj7_FGRV=>^kt_Qg3F5PBs8vp9~q1;@!+ z^0_fSVW>2M{-Gt^g7&p9EHnFQ8k!GWsbG$|KA`>GuQ$z=HEqrA#~+(Fj#Z?l zSH7PT+~=OztA)PZICa~$v8+D_T}~2(Z@fI9*XA*Yc=`K>K^_h<%7i?6)skm_Lft=^ z++m&GCb7>kO7&_6={3S6>qaI@cIN}qw4p)1QE$#`pCp|)UVX@nmr_9ODg=w6|d#1E_rR! zJ}(4xP~yf!W>|!hIpnkTbD5Gg6mLwvtwO;DZ``TRoQ;Y6dosNQwyVhSDAD(V7Ybi7 zha;U?^fmchM|$IwFYDN!nbkg%`P7^v$bTxw03(Lj=OL5qJ|8 zj`QauFq-e*RUF0)l5q5CqlKPY#bs(bYaHqS;KZJYG%cFfCeN6|p3I6`Y?=@O)e`FQ z&9%%LjlkdT)LO3b*o|9d#HhRx5=w>08>Cw@;JJ$#z5 z4|J;$F4UIp45ok2ZTc|QXAa>idhb*>;wa}c3pJk+S6JKGNxo1=uf#f;7+ai)W3{s| zZwUQ%qRGEUWTL$y3lAP;V)_a4($qVq24pf1Gy``zE;grTcJ@yeMx4*Ywk=uMJBmI& ze9lHk(yO2;GpoyzmE<_K?*=`psq^=3nT513?8|7voNE4DJ=Z$b=VxP~ne}Ye!XNNe z_M(^Eoz+O{wDlC*W>0Z==OyLlHI!BKR(v=_C2`d~<$=4mI5zNJfDB23e?42OX7-EyYo;KM$fs9s-5?Dm@~2n zkUbo(p}$!mZU>QF{H#G@ELo@_!SLA|f`6!yn7xCcoE(V37lW{JIr&BZVBAR!#`|{~ zGT%XXdY=2g-}H*}<=3e>4H*y&$1&WK`wqasO2Ig-)u77kAl&F54C8Fp+tooR=*r$l zezxo9Kn$S%u;yzpT&J>Ub~?EyYT&&tvVZV8`KOuDFf5Kj&&7H?urc@cb`<7QYx(98 zjmQvY8nAzF!AE)m^dO&DL603H^ypS28vXn0aV<3(tLt+A%vwlv7CFXeQ8;j)-gJK4 zn^$EGULpeD;BjOT#~PSs!R=LDS@PbZljT zV|Uh4zNW!h!`uW{{<|r2C#G94JKchDr7dXtFb%)S2rR3bj=!nfkG-FUO<`%w^Ja}9 zkUZ6C3+5^;P@cEoLlgQ-tmpSgI;tt?y|dT?EKkF#GU>S4n*ZO7dDTT0d@h#`rz%zy zIa;Y*Fz0qAGie=j@un?37u&P$|1%dO`}5ze@^IlOGp-7Av94_%iU*R5s%k}_DfEe$ zMlZR8+=o-^3dx|(lWfIZ9s2{PGG}QRYvNt_*-fli!oA-%pFHe*$?qL%MJC^0KbyHJ zW32e|iFz16yFb~h_&8q)Y|UQ2jt%A487JxC!`$aeO=No~Z>enWEk`!Ao zwJo{C+VnkL)=0um`bzJ;Zt~%(Cws0{vZ=JUc=qy?e@`l<4msf8$Gl`}inn;>(U;NJ zM}l?k^4io$`k(TWH(%W(!LgCNa%d<{yWHg`nacA&J!Matr;OXlEXCh;X!zu}e5t6w z#977iJirbgKGE#j5XR9fD8Jm#hm`xrrRF5CCqF|k& zN4a)-s1xbQXwp+xV*mFsJw_g)r&dE|nRTT;@_^6Zh$z$ypvUQRX2AbVCNhn@1+}hI z_IeEDb5z_>j{$uCa_>YzrDV^%AL~f@Q8>|@d2w_3o<6KivQFCRPZVn}Y1mxKg2s*L zn@G*1QAZ2Bs6pY&?UZh(%+O^M}9pEN?c_7wI0s!F*nhr^%nI2IpX+33LUMr%R@5MmnAI&08#Y;CT)?{Nw_Ma_ zrkr18GQ@q!0wpmwBPEwTtK^FLeNSGpFO)U9QKPKf_w$+gNKUx971>5B8c^f)A7{l* zYYyD`49>kupH+U=u;saU+LD~ijtk~Ky8S6PdOc2=5KuF9^wgK;OS$D!t4@B@u5G(K z^Q{#+bN{r?Z!D%IN^`FbR!WywwLH22Dz4-bD~Zdqr!`NgBc_F;PWRKFVu=4TJroVmC1in+c2 zUUT?sm3igbShMSuz9~o8k22HFC}ZeHf1bT6ovN^|SI;OT*-uwgoG9aR;$_&BM7iy0 zloNC5k@2@drteOYmiyx6NP4`)@ckLguE@+Z$<{sxWixwRX1FIx$V>8yiShEvKT&eL z*-IHi??&cH7k6OK3wx4u^o1;IHb|YMIB~s@ApPj$UDPQ_hFv9}I9Q1jTpM1=@kXP@ zN^H5WqPG_Fr`xMAg?xdJ9W%~4d&8gX!`O5$^y;NV@=x|waZPzQ&>J4JnG?5*zKpE9 z{e8(3XA`{fG29zD551A5Q^LLxb%amcE0{ddE`c5zcI0mgRY*%xLRE<#{xiH$ae)uk zo$$q4XV!emYf+^){TAur|9q(y+WA`iOpU;#2-c@sN1$~Ed#miYetgd!I_~eC&uQ`Z zYYRwc;8I%bCD-FnAsl+HJB#dfm>Czr-&Y6y6)j48(3|lY^8nZf z^J8x~Vz~yLv5PgY&)i$HR(Y3u-Otnl7PesB^l2hC3^u}(Y~%E629)AnH0K`!YP?|P zG}n*i$OkoHUCMtAwX+S(k>*;jQ3E6D=?&=a$3MFoaq$rMqcGtg>H?NMXGgnD=;@;Z?%Oy_!V z2zyeJGcn24)MmO5Bd5rqfq4}@ z`8@+zyKBqrjZO69&nKh9I+`anyHl)pqDvN1`Tu#@TqEw!L`EF7v!z+6bSVq}p3Q>Y zqW|R?OPW=Z{?t)+{Od24pr+E%$5Y-;Z6qtnt$(2xud}@Zr`Fmb`lbR~`EQ?cAvk(2 z7%}v3+Bz}>#o_eUyUyI;wb4KVS?|ZJEo_QL^-^TNa>%H0{PD<4$DB%M(TC&F?fMox zX3s*m=T;Q3mLE7H5B`JbdtkM~Og3cGmqy~3+d|eIqqp~AAGt<8#MZHi)ELLC>vsx_ z+^@ic$IK1QwaLc?3S8xU683;z7$=y!!{howKkP-zHO%Uy*FwE5C~+(rt#;`V97-mw zEc2!(S}^_uGtB-?N2T8uOrMaBHT0Ky8JmY5$8*szn7kgxAN$Q@t~o|^%IhHSlYQm( zEqW<$Yb4z^vMv(tCp|uK{!38cS${jsa3W*5(;tpmU4{6X$E_F|C2NfWF>d zJWo@$Fw2@AgeS?x4@jqdJfr?@l*_B}2Bl}Q~ylFG85%->AMtI3Bc;*mIzBwA+QR$cvcovZ}$vu#> zT+KDx39|)BTC%1mt$6Ck4DLGglB#QkGuK-_>|0tm%}s*dsO0<|cc~ssma(vjxYSjk zOLnpBHYpJIojznmHgW7ghHzUjt|bQH$>m@ie-(_BI1L7KE&cc*Ye~iI+j+(L_bv0% z(&>B5Idlx?KeyUvp@_C%vx|kdb~^f#Q;EKshgx=dIPf|bUM^P5{@aSHjp@A=;wATY zH`~dr9={)OozJz!suf(P_adLt zGX&H1^p7mH1(Cn>$YHIo)JHwG6)+=iFg?@$wZO{tXv`qa!*eWXy~2VE3+X$~W3l5} zu}iHyw6e2eR68q~1+x8L4YKs7QSO{&U+cod;@T!r^kNk4FBLT!CHm3l?;Bt5G(MQ` z>Uohu_&3dyFjjHyz%*(ZX>&dANKdW}P8daM}pvX%qPs`oaFn!tD$6*V~$f zHfvbR|Hhnv7TI`5FR9EO>_?^NUv28hjmS3c<-dC=k4W3?Cgy}4kr~k@`E}1Es_zE* zPLJOjiAv1>L{25o2Zj=ViiQ!R+

53LT%t#X`a*-QHQ1DQDLv28vpkyBqqzd$d{+(TyWlolWJwWz&{OiHR2 zo)+@)kLme$$p{~wpFj_CpW!?|WGk0;BmZgS`Qbi1U`iG~PbSO#j=42tx?N`|)NTK= zQ?GeXkB9Z-JWnaq^<3=Kix4L%Cya8i-a+vmlPD(o9^~F3KjT7w$j|h)qP`Nj!k3(+ z5A}N`Ht*s*H%N<4WjKe;)1mVSEmo;`j>;LacbgHDzA)?IF?%jKzqHuJyolFX2+SaZ zF@?U2&g9r*=|6EH10Tr9^m#xZ#52rT>Y-3yWi4paCWU&&4dyM;7rONk`ahFHow+4R zGO|rl`nC#AGgVmghyKamsre{XxE<~bUwR?O=1?=9q{A=How0f?@=I_oJx71E4eY_J z%Q+3q2j{VEre1q5HJjdSWEwdyEp5ZxYo4F!v+1dMo%{vsJYP35%V)7d{h+5py&{cu z5ccgJdYmLxxE`wb@rXFhG|KS#Nz%@d=Y`j6+)!VPxU9tS(Z1NZTZMYdnbp~Zy$EDw zY#nqM)Iy7xC>@^cHsL`b=h9Q`GrdheGGA&m3Cz|gNqw4+|C_p#biOg594{_J-u&hGnu$tDWk}wZBRFn3HOxJ{H0RH#ukaoFa?IG$amY> zWTe_2A&2eI?WP88=5o)`hWi6^2zDj1{y&j>lsWWcToMh(=h0Znu`%|D9#6Q=-yBG< zKbr-|?b0zz$F(?ly=PA3^4Y61dm&l#9rQpPlZWOZd6-y~i(`ZRr8)WcZSOfIlaX69 z&{q;;Jfut=JM7Wg<4c8-I6qr~aH9g1TH3+4p9bHnhCo+egTh*z$EFOxp+GX{59kX! zfEmwE*=IF{eO6nU+wc!x$GA84NymX^=~(s5f=3o<6rYFa%Je<{$Z_xq zJ#ko%ezw#{dIh(Xq)shm`!sJU#Xh=s5zWNw)_;t-9fq|dLs-!c(-#*?rylm`!nwS9 zGW)-V4?y)0dNW=Qfn$>a*vuub3=kZO+7apZjp)IP`~^T{Fm+yZ<34M+U5a20cm=6zX=B4$Afq z2KmI^uj(*K$pc35-EERnV|;+eO8mahKMOdIUG}9XEBmob9B&?I;l;Yi!3$cf^w6QW zmX7`EMhvEQYv5cuslE}R)PaxOH6Wb~+Ta%K3E-TyYj748a@~AyCpF!xtl2!_G5jW5 zd7CUX$Hn7+v5v|9ghli@e!cCWJU?raylX~jRsW#ajrT=dLlr)4^+j8b(^opG5U8Y| z?)}9$_n00lb?7;GMvL~{n5A5idCw0y9;X{o-p5F0*+4%UBNDi;IDR$@>7U4aa&BM4 zIsV>I&S7`i<3w-TEtl!%vV>kZ~(V^v2@_KW0h`+%(Ka<{v)l8VkT3^l} zBhIX5UePR$(bSgz*}4(-S#|_TgL+LaveH^&&EsIlGKf zYE--oox{XoioWQ+pWec&wfNVGo}SSW ztiS8fW0($YH=9`ZFrw)v1E!2*eJYPy{CFdx=44~_V`g$I=?7Ai>}fnb1PocoCQrG) z8#%^~3iYp63iW-?VL@Db=(;D$=f&J}k2xq(a8Ul*OFyMcM)_WiEN)vBLYH&D>q8EI zJu|WT_@Kx~hmG9Jmf-bzQALOMlXdvgo*7i$CggIj*T~<5u{-D+`ON@js0m3LW|MDY zO|}l#WGCqHv^*1^`}3H}GMk+1opsOXtI58F4o4MgP5l4zj4#X{(y2CcQbL0;uM(fr zvuOx!X2t%xb)@gtA{lqIKYCw@LguS9`ZVRDdm|^w2q=^@1^v+3NsqUNRD7RBU%#F1 zvY$R>3z%=)$CrAOhGWlcE3S8Qm3QRbIwc3<26bb@KJGExm~l@oZv?YjA~y$N%+n~G z8N@v0Usim);V2ht6-fBz0QRZqk+qf_;sR=|^_-+><$SrYy&t?kZN{Wy>^HiegOXmIneK zl8d>PhH_lXtMZ*?iN6B%3jd5J~1%eL27)mXD&DAuNrKaVicNN3cBH4DKKYBi4 zp6o^PswZ+V(~kaAM-qi zF1KLAxm-kqk~`y`$md6Y%-hRcV;wceJGmG+*+rb0Gh6d-9#4H{%~(^(gs``Nyob#E zPCq;T+_i_PY0gQ*@;c0|E@~j>9ExOMBj!_iGq0w<1qXQ^9`tdOBYlfSM?P-o1lAOI zetJ%z9=NT6R9%)Yr+P4dX8`wA*=ewUnTzPwE;5_`j0c!UJhmhI4$E7Rsm*1*u%75b z3q)5p2y<$(r#yu@%Tsd@aokycJuVQ}s37#2$NENyg*kQXL1d=U$2Eo0pFQubIp3X3 zPDO>oIat!LzC3-9FC!ZS(4!;@ky$+d4m_Xt9mQpGft*$J$B<^^<5O}wsS7Y5}g9Udsk~{Wxk@#`+(_9^dOkUqI z?@}>)S}xqCG!XyG#bO`I^UyO2KY0I?Qj%BQQBPXz%9o#a1JQ) z$m5rItPMbobowwxk%v{#2eX8e1U@Q|FE@e^{ukFd=hG09Y{l5EUh?;?Uvj8xAZC3h zcSf#x+l^d==eWq8y9JWpf?9cF@`L*=^n2uWAvYKKpipYtm?W6)o2=9@=bd}!)m5l%x3yxir?Y&Y!0ZU-Dc2~7#01uajBm-M{&AA` zEo@SfTx82@QP|_22HTt*q;z$ZRObSj#{BUkubFAYUi}K=b5MVF14%qpB&&0Rkk0Y# z^V2j;WUVIPWqsN7^^bH=1)=gXa)qbU5ZQt{a&M)i(l0etOP`WKdR#e`hGEp4eL@<@ z?#hMo?>zRW^om9d^Td0P%O#J*+`41`<+*F{{<EEg|QU1cz9B4ZwFpngmr zQbQW{kH|$I@~1)Zza^n-Ft%OiIK%b0BGL+dwuhKQcs?ulN9Day_(R@s;~Xn|+wy*+ zMsurIAaYleBc99OD<=ohX)dy6(I2_DH4r5`aV%k+K&JA(D$Voht>*K-g8XcDeOc*H zEQeW_In{*q4D#9sBXV)IR|AP@QXuO+0#J>gAJ1{`#vv=d{p~8x%N0wR3LLk8)BiM+ zymo6VUcp_0$0=~$f&LP&qtI`08oF?tjLMFa>kmDU+n7D;V!#`&Q(i8i4_zhlM4P?v zHgFM6oH0UIhy57KY*h+o?> z;pM{h#F;o5OAc|kB^=#0(l@OfdB*29ytTy3fp_$0vXPHFMZdg(%oTlU!~N#5^4A?D zZdM9s{vCOo>C{el*-$v|fDEM%WA!78z-(d+t)GdYOdG<7#L8BXI}4$g67^m;@{E&8 zE7a^Nk}2!S_hr#vvKxJlu4kea=kYa~{qpjJCw-$La4XXQ|B;!nY@|<|bDY>+^v12n zVR(Oz++|t%^i|sI9+duXCuh*sk2J@)cHqjvoG9-5{w zhq`0Dj3tlLg73d$&+MO6`oxiU+sQnqyQ94^*C8C+2a$W|KyI-&*Mhcv@|wO^dve0j zw7db!cs{?j<{D!i`!T2sWH|A*~5O|P3cVhD zW3T+R(Hm>xxaQ&cxuvEr(`g$v)91^RdA>g_VQ9CXdBi*qr{n1>7r0MC4PMl(!{KV8 zpVZ?FJUwT_xAa)~aM%lf=7nQA*N+PhWoz9=TqeKQ?UghWH#7W<-%#TuXtxOH2%Wt0lvgD*b#>;$_7uxTNV8154 zr}}5&KtJjN)#Ajvv?u3>aD>!IL>jrOp5>T%@o2wf?BRJB%3NA%^M8%bfFh826aH~> zdY3m&c498=#Y8*=wfULMN%uC$`bXpzYtt*C3;D_u8Q40I>;8HNq{MtL_{1-SUj*}@ zxo7$5&wYwtoFupY?|zQJg~s&X{6P+Jm<=Ny#!I5X19xsmU}-*c#;<0g^jsUP1u1fH$rd2X74HciO+hQ~^p!ULU(BJgMhx!UI$ zSpLI?cI1C=Z}CLMaf@)Q7wZ>W={s3yL+6|XDRa^r?iClo(2ie!P5*>k8|tuL^?fCM z8^ms!*3To2TSM_f#Q| z{DL{-W%tQ0@;Ax-UfFSOW&lp&#PYV)&e;zke$) z%<3GD_zld>;@8cIUl7XXJ6zV44@p6teuD}=cZDc(r_;m(u z@%S%{PLPymp6GKrj9yFJ!v$wx=qMY4nD=c*e((u7)`2S%vFiwP+xhv8N5{)_@~VT5 zMquX=>Tv&Npw-o4_B6&zRz2n{FVe!+n)R728TjR@PqcE&3$35Y99BUf3arM%7#BnDy|)eKuCX#`7JI|` zL?HFH0Tu3Lz_T%V;f=AP9qfhaY8_@T;dsUSJj2BCs$jotbnvD>j}|q9$diVUPvRcV z&uhOtyz0*WNan7cNQC}d1}2bO9Cd|0EHAwkxt+S&!S;uJ=eL)R3(fCtelRnw!@T*#i*^-4j-GM&Jhshl`s?&&O}b`@ z1Uarul+yn6Vhl)lNzEKHDPMF+%>_f{A8cxHnpilTI)v>(UJbB>1_=95LFU!&?l zf|U3X&y0sSITMg5<=9()teBi+g(O+kDqe1WAQ$PIDB<}=iR0&HG(9Yf>FG0Tt3e{E zKNx!_Nxyjs(&C*#s&Fi7_DG3ELwt~C$DE_dDsUI-2eGNPt{MHhYBOmX*2bPs#+YQ zM`OR%E36IDgN8kvRt3ZqI&$ECbH-`}&Px zPp;005$6n0tY9B%H6!l2u`aEmXMmdlhsZd-AN@c1UU6s1N`B>M9X8EsVv(?f&nkvCjpbm6>GaRW1* zBFTf_XYN&(44hJ&GimJfy>o0_nD0ftS>JW)|474@-eVGw3JRLV+gik6aXAB+Ww< z7(IhABD-*S@kpN~l56`=&3y$88`zaJa|* zEx}M}_^QG@#HN9$`$YqffFNvM6#~Cc%)gD~p_dLl7g-ly_JDoCJ;_rguy2^PkcMaIk93gSV`w^> zEK9@rJFG*Pm<4f*pEZE&!87_O=~+)In}?~a(G1^6-QSb?TshX#9j$n@){2{~Db;9B zjjtYk8+EL=v!=XxWiGP)m_KdHLGgO-cd6;ErVh2bBQpv&SYdOdwnd%hELnk&s?5Um zv0@AN;||rV_#8l9OPPm?_4BYWoE{er^lU0gUx#D4XyD5l2=cIdv$w=`U~gN3N>-2o zejCQ;=eoBHobDvn(H^pSwU>NaO+Tk++}AE?EXO9hNsBS=GO%17Y3JZ6Q`49k-AE+| zCc29sH9Xe`4W+o0pG;ipB4q;|#lB@jDP7Z5q$~5KqgA5)%SUpUXC10l$+s{s`8Sza zla2gkZ4*D4mBr6t&))GM>HJfaIYm;DiKC`V9>>pw-ShR-Pjs`czGo!>l816|y zxXeDxY&Ch0pM3s4@;T85G5bk_j@y`bGn1KFjYHt!&*v~X7ku%q+?E^dudx$7^jgMnBi%-dgItU zo!&2e-nRdwPDgFBEuXjV(PRu~rDNg@3$|BE$9|V|vLqH9+R0p#@HBkOXTC$a1^$Wb zBd&ZF>sMRwdO#YIhgwkQEbE0@dY_Kxvq>EzjQ^*;o5mhk))iIk-ygz^yno3N9pJMR z$!BO4Sw}u+q2z>*yd_V3j-IL)EQonc&zXF($o1%#NK7C9-kWFNLO;L_DHr7Tx z%Fv6Hb--Y1UNJja-};e@**C24+Rltdj~r6%}1 z7b{QXBJNBse2$V|9B+loKUS>YO@4STS;jrgww}!Ac>sM%no^7OBG2;aKDLuc|HILk=PB~t|V!qINOZ!>*uI8Cn8m5*QaNS&Qr>gySlfJ#_=*D(KvMZT` zeDlnqt$kB1|2mo-YTYoOu4&(XcE!KVqo_{R zl9|!I^FmIPH|}3kqLzj=zEE-^1p;dNpq1KCEtt7B^l* z;BDUsGzldi`IG)CeDzf5aNfoo>XpnWX{p7tAIzFKtA#!HI7cVa3uXj!K9}>oCCCK* zOoVMR^Pb;vEyy~Po|?)&t^qI4GNOJH1Cp*8kg~~yDU0dLScQJx+*?*KQ1{{*Z~I#M zE1oexRo;XN+ymF<*W4zu7w`+$o2`xbc+r4>^+pUEM%|(g*M`(_-aD{YMoZ3-YtAx1 z3@FR`WCY(o%3#8^czQhsWaAgtY&~{zy>>4XtEOjS&;+j8&a>ZTHS3duGg03?3!{#( z2KJVo-9|DT+*_8eNY1f6dqY|Cy)h{hi@25?=fzCf5@du9vv-#J=Ue>$rGA-+b;w3X zuK#W|&%(pS%%!fHg;q-HP8Mp5Ls*k#ZFYTf7QlMsfBU!pUQg{jWKR(1m+AD>?x7<0 zt`h$Pp0d+Jfrk%SA2HgYx~2r0^dkdC{wveKvAT$Uh*28)8-!rQFAWOTX<$!HIQl8a z!K=}Doxy&KylBi?7mbS7=>yC0t((?D-)#%}e^190e`aRV(<*3RE?O+IB8=mQ%M;G+ z@yzXnpOo-wB2y!LCHJbIIBa58W&=MdwU50183jHzvqMSh!T+r#jm*HFdpii*4lx(A z30d|)4OXuX!NJ|ZFf5HGOGxJ7F#QL|(aY(tEojIwJ$11K_D$(G$g%Hp4{~UQWGs^{ z$oNd}0**V6{5kK(z~zy~_@Nrt?@%*r9hvUa!#_lt`dgamWCKHVVO=3n8e; zdCZ=#{y(A+MUJOkbTs=T$?m_QXVYN%ZLPH+cr1JP3I@FB?b(*Oro3L`Yx5YwqH&eX&ZnvD#ksNthsjyqq&HgHF3yz;)6ru$*Of~- zPkNE(;TkR9^8@N=xTfouhX{HzUOttF4tKp}LfPgLX!eoe_gY9z_K&o;c}d5br=SGQgOp;gh z>Rq`hNnXr0N{!(OQa;KDrQLk7_`V8b(tWV&tqRj~l=z^~!ihBjpHQ+O2|AR64vABA zm@&$TWw(szIM|4}9M`_JHDY87=HAa`A3OOE1O1!aZe`)s4EncL&%)IOE;G_g~k9&C_j9}}fGElHaFW>#jGBx(N6BweF@a9QIE+jSq9zp0>F>_fK5 z2U!{&rp?o0*`NsgY@|c~$;_e*;`p1*{WZtFN#p59OE$cW&43lX=;Oq3C;J9_e9vX0 z+JkJgo==W?8vSOq3iZFs6zVQb?bIXhku%_*J0J3E8lyxzn5d;BNuS9^G0!(j=^%r2 ztww$@i&+yk6?TqQq1j&gBetgp*Fw%M-t2AUIKSyCvm!V@jHgy#>KOUTXB@{r7|4bh zF}pg)-j3u9j*|Zlqo3_fj+c(vC`aDmE%Qxpj8UlH&||C0UWIyi5`71q?bME03Uzu7 zvLH`P^1a9?R)3QmrQcS|X9lV6sX}(R3JsmfI9&3ee+siCvX(qgRaYh9S0&C(Q>b5jH)7KqdPh?CIAWmAP&*41 zdG9RX+>yLK3+^Mb5ud404_aZTzR7EKlz*Q=|HxYj3Ux#FU#!_e{?%|$@}DG0nV3T| z_2xm*y;mY#--zC@^wsR#2%6?x6EyI_p%FS^sazq)__iHlGl)A?uer?ZkYL`%`KX@tBg_n6evGm$v{mXRL zL*hpHiE2UiEi^#JuTwTqh@4;C_aC;P3Pk zzr{7~6)Ud%Wbd4g8F|;)6UTkq0rG>V^XL;fUnz>V{!)Ffj})dTuzIf@3ai;eQA&Y? zm3Al|WRt7MLU5+@0Q7he1P?N4XIh3pTP+0rr}22+(#Po(xo++q`Zv{M<9hZ8Y~p(T z6!#2yoJUWjV_!0}g11_5lXK^Q#a0B;e{kgb57@=|HJW4eH+nIua=BOC)>snG_{sd4 ze$w-YN>Vs~Mh#NH|6P$Jne6ePwgNY1(?4=MvnL8Q`0)98^Z_fDuKj?@ zR?es6eWX^3uiP)~DaTDsr1Cp&i73I|K592by%jj}LV*USi=^p!dujxBxEMy3k#p(w zLe5>uAt*a_0F>DpjCG5~NRG!j1390s?vWJkMJ1x7PdbH*2{>CJEureO>1| z=lssz3g)b7AbLCq#4$hq{93#w9hmd>(WAvKJpya!p*q0YOKr|? z{I;NoIpKftJ}=yYrL1W@J;~gTXN}Nka#ZK7$l%#5#26=~h8~iSPZGqxyh#Qn9+bE2 z)jVFpoS-B%-fwupsj(*(1$n~aN1c{WI+QKPGr8Yl>UKn+Rx@hncHo*{WI|pgGqo() z1KdaLLDp-BE-+KunzhYStexJ?K;^vl1R3W`9PDrW3w z9K9HBgq3kDp&MDtBPI-Cyjs;f3q#vxVy9Oo6r7{4mq!l%5PN~1^sT#1{mQ9!8g&@= zX2y%L#spb&I9_zI2c=7_L8j>vrBs&$8O#2}lVd8pHmgy=o3Zo2P)jdm7#8saeL1UCi$)E@gZ_OrNILWKUc1 ze%_XehhH+Gr{4bi1(|4`OHEA!<2yOV;9!MjGx^*n)Qe0Yqx-x6|Hm`>T&^XvRu{@r zC+dH3KDPch)_Rs^qhIC5@_QV0$_Dr&upRa6o}^%uQw~nfb(8hC*Ba12XMQ$p+w03@@;Hr0 zQ?dMFBuacuMW@x|Xo~8}{E5Xft`E7J?opU9ITZtHQGc+ho0Q<=>(!z^N>CJ5c231^ zSP}8gS+3v8lczoW(PDZOf@0`joS%&@b85-@)zlo|-2b~yQE2@x1t*I*v%1SgW}GRO z-Q>S+4v(fc2mOA|Sdmbm6xRfDQvT$yg2|nc>zop6#g+tj@u~SoQtxpVYDXmg2~WZD znpSM+dWAd`SOK6 zwqMHW@w_JImk-e=x~_|~^Zz4_s0a6OWEArT3;u3OZR2@r8OoY1vsXCu)8mdy8rrd5 z-RhpR47vSB&ir9c=b*=o&=hq4n2l>{XKA`GU(`xJq&<$pkM^8-F8T;fbR!x4f;tWj zeNo2{g=_6upJ%S!xVBOb*DREME0{kY<@w@CDozwwG3q`!&3Q#K|Gh8%sU3x*nPlD> z2YTLYBBhdxWED9n(?#;Cc^1Ug%E8_Nj#9(3K&)p2v132`231oLqO?L0Qb#mxi=<}T z09ZOiK@O#$j63V_DUBqT{=Xv|`r+`0D45AZm17O@J=D^&pipYB^+$&R%(<#?o{n7M zC-$vYarXYgZ1TCAqtPjW+*S=K&DQ*Z7N z@57{w6h!s3BJ4&(sY>7EzB)fRI&X$k)(C?#kSc|==41Wl{u?jTU}r7<`$6|CXYFu_f-sa469|M?nYNBX!?h~=Yjb0 zBnoR8Q|q0z!fRbaNysP?bp-V;UXfe;l7c?T*;p1|PnK*ckkee(b#gaj@(S{6&B+(1 zxXH?ktj{}9U$RFO9N(s(bVxRyY<7|y`j-vo{r0X^6#TuYqsQyxKfqZ6>3ue6nlBPs zvfgn#1)igWr|-%Fh1q-pF$j=jZQ@w8GZKQF^Z|mZUnqP;xzXFQzYfMm8$! zXe`-nsA2HQA6ptnVc+T$6lG;&_}d0D=175*t?7>j{JC2;r;`28#^5iUN%1U_s}bag zS=YAfN)L`iD~@Nl%Z719Vo3Fc!vykl6D>fw986Akl^)ZJq;>=H)J@2ZHfK$`d^VoV zca-}vHksw_kKU8GzdcOBq@UUJ_oydBHj9R3qo;KRFt)FUSSopx$Djn^+IzNmcqpZ!X7qNd-M8(yVAO z)=5^(vB{?30F<~Ih22xQ?=9eZzvv>~zl!DW=YCic!F*s|3WmJS#>cvi<=Vr1X_xDd zDcm=D=BFUDi4~PMILT?pVyXGb4-0ovdt@;AKjst9-Tuiymwe{zu!>QrhJ$jiJ8kQF5{eB9XZ}6(xAxW~x8z-?VJg|!TUy;?Q z>$fQ#KT?XR-5D?I$t4}U7LFq$47j-?9mBrZpgKsMfYM5gR#I1qyj8Du8OT3ogPkc} zI=xmRe^VIBttBt>ki6b<8;Tyq$Vl>NEvZ*nvAU6ZM(J3+g8tEE;$^5kHKBUw@O^_3 zb=){hH`>N}W4sjB=lp+a80>@TmssSB{ZQaF|kmsrqEAP6Kmuwb}HH(bc z$?NvKB+mv5$Zt|_uJCC%e2Ws`RE8YWL;B46CrITD?uf2NJ-#Ti41+S@z})C4CzTf+1K&XIK~}s8inCacj~)s zc!0F6^qao5Pab|y!lxm9ll?jWeG`ag9f_t(J0S*>(*tD(@m-B0A2EL-!6S+JGhXirH=Yd_Ex2#z}j#WV| zC-QW06**_ZvzOESF!Wnu!1`$Z+%ELneH$kiFSw&PN{iDm)P?j(=b6KXGvNvHiuYR& z`j5~1%Y?r3$dk6G|17Wb_9727<^AUCXv7#D{lr@+G@j(7l%=SzSBgHNSLpjZBNNLf z*)aA(g4A{Lz_IPr%$jb1`=xYLT16k{c?aa(d@?jU!*T100Y`bAGglNNhdx{H={Nn@ z5X!k410tGGFYg6?gm+S>^0yj22a|(i{eRpN>eDfYsZ%>%u02y?!d@-fjApN46uDh1 z*F_?~&mPOc@8S3sXheSX4D@&BnfX<${G6`h8C!>o9Sm4Eh5DYnKlh)Gl{(bZTnj=bF(ns9 zf8OTPl}Ip`XC0+b|uCXOSm870*7J67HYL{e{v8 zd}aokF~4}$B9^(RJKo!cqhBNTWhSKKZ4=H>{f?Cbylz(}P%~|x0Xve?akeej9e-}} zZ592H$n7p>|A+kD=X@J_%}fwIea4@xr#Eb4Bl@38$L?;-5$MC#b0T|SYHDI+8Zc}c z^Fh`MHP>V1!Xyd&v!S?OtQ=oSJ<8HL@*?zB2$Q|$mG1w1CrObT99mO>YIH3$&pS@y0%GEHRY3> z<|vcrZd{NuteG}BxnZy5i=E4*s56@-D}tA$e0lOS`SG3&Nh9qBr(7I(A$h~hnaOuI z$4ZGs^c1`qD@ibC*rk2UO*Oi(M{S~a)Z{8;60It@KlH$w%Ur)?94#%CXcMhO zqX{bXXs)8pA8S8@`P^e_(-Sx%XvnN8>@8aW=Bn(QuKaq z!To!|agh4LW1sAIJlepZJIlXPgkdH@+mL@GmWTyf;A`B z;=Vev*3{I9;cl#fJvYL=qv3z%Ia-X!K>4v`8EcSLXI&#Ui{63zsGrDQ@((|9i4LsI zvu>xmn~p~>(-AU^yd(d9HJBcOx3duai#4JO>^+lbJi+sbS3GO_`P6V2!P?rR4BQ`+ z!CqQAy2NB)G@l#yj+#BqGEkNMkun>&&!us0Har7&lQK~Ej*IB;ImwSNu3|0YD#KU0 zN#21blF_J<^kiT5YK&SQ{PdQ&SJcvgjNBnP8WI5rm5`S;4FzBT}5+EB?*JvrQSUk8C6Fq?>;!lGkWA+iB-#4 z7YF&Z-9;+pJIm(CB3VO^TBBQ`oS`nk@Q`BJZzz;@T?(X6WBTT#70RAlHreY{B(}K< z6k3bqpGE9NC~Y!vK%unKu^+IZP}<}cigtnm_dh6bxV$|=J}I#6G3yHS*s!G1r-J%( zBO(?5ovAS84D-%kHmN*90sXf^3Gq^(^qT_doKPfNE(IWOus=pJKPf&>K5;y2!Ulgd z=^BWLqXCHP?~nIc0VrKJ2-UUzD0?LkZ6C7Vxh?>Q9+Q8h4t~h10Muc9X!XqieNq_81qD~$A7-w6MZ~WxTdCUM9 zILo$AP3^W2dX1bUd*~aDi-XA-DyStlPmf>6qTrB8Kk2biP%*D>yOTL2^R|ktjWjew z!}CKlCasP}ZT=~`7KP)7sU6pbeB!Za+-5#r4fL+c(PL~A=6a9xIJlRyf3KN$vuE>t zD4$cCen}tc$J?Dcb6+E|ZF(y1>?8Z6BU|`4X9Vk8uwt|YONORmeFY1()>83r9ri7L zrg9dBnoA=r_{u(pIW+|r@>4NA%Ys!g7JRS3{y6(BD?U+Uj(y+{tf6=QmJLYa*&Gai^&8%Jx_GVsKVBu>X{=gYx>IlTSrJ;KN92mY?acuy5B6q2w$o_hZ zU1XsW=;aY(rS36v#mK8&PSh4Xr*{ne7E7~~kdLS32s^lWji+%8s^r|*c zd#M_k$mu!Qv4LJ;Q?2OV&x$>)DQvl5#r%8pHrPcy$FVt>$J%~l{@mn|IXK!i2cgc? zbUf=O$A`H~-c+*#&P?;^Bbz7)2zM>5yU&pG5PjMTUA<~--pLdmaX z2mA8meA^dG^l6*etuL0h3I%6j6zH(Y4(@jq@LI1xzdzJ2YLh4WM$|Q}Xp^(;xW-!2 z6NAr9=4|c+YEbpz_h!^5AK8zdp9u=sA0vZ&%_bEdDA4nu0&DqCY^egk!qnB?K z`|<3T?TNyucGTM7bL;w%0nQ`GxQrU8>@)7QM8S*eZp5!>{MDA6%5&!YW%QVMjWv_y z>_K*9Pn2tGq#I{fE9h})Ai2imC^TIfg<2`pgd~TU*ns`E{4~s8U_oXF3)1GZCee=b z&2=rvi{jk-u2lMHTJU@bXOex%D(f zaUQljHC*_5e~nJVdnMV%0T${yat(h=)jrh8KIOmAPj2bFFOsI~SIAIoKU-#f$n@tg6n}pJ+vaFV_;+)`LA($RsOnb>M4! zwBpiKYB}<~e7%{`Az-s2<^!dOq2wl^_mUgBHBb3E&YbMjvs?0`1@6hG z7tBts!L^&myc=i$|o-+kZEL1)n?SAO_7xpVtEDK#d2 zOty?Kl`^V1=YygXP0$S+E~R2pZNu4Eoh)-j87 zhCv2s4bpXQf|#cpr2O4D>CIVJyN|Jwc+4OzwkZ*7@WAnr*8l`J-Duf!`MlF1J#_QfdOCOCeG!53$ z8%hVuSuIvZ=ul&m7RL&-_^sqwbNqj2K+e3((4j{Y9qO#qqTj#aXy29dGv1t6OxNK{ zNqSm$3d7LP;b`?M9Org%Mp(yuMMux+_S8y@CjY~FPT6woJ#98(?KJ~3qsZipFyYY` z)`ggJW_eP(it{PGa;P)LTGXQ)o-G57a9U+XZ!L37o-v;C8otus|tmia~qj&XRnF!yXfdOALAScuRFV9#q z%t^=yN*ejLlmXqEQP0j(e!ni35j<->NGpLq<`NkBnS1_=BAG!x@Aa?%OjyD5 z(ruL<8R#bI2Nm{NcRG7y4rIJx%VEhIQPFAC^tSu~=&Uz2Z6L1{syZJaUb~bt5myJ?10z zPP@zWhArjR-`=vblS+!c?Qyx49hPYAF_&kU;s*BEI^8B|C414py|Jx`$-mqR0bZFN7S?|c}R)!j8B`Vdt&<_YW*GZ#IAdu@UFz!M%DwS*VAFf z3LXBQ%=gkmhxskcs58oh3*qF>gP7ZICmY8cKZN_@kwxSSoHMa~DRs9hX2S6+wQYYZ zG|&CXf>0MRX{kcfhQ6j1?Cdmn9xtEU7-bh{OskYN%f{A+1dq*9zN3ngJJd1u@kCD( z*_{KP2so@lLBqw^U7*95<2u}MqBdfV4t{&cGfrWhz`)OF9(x+Bzu9`4&|hPQ*P%?* zKc9)IE$OSepKN-Uhd39Rg+b(XG*ftudMPwLsf{?a1K$hvwr=^GrQPpDxvn-#(9r}r z{qm4FbvMi77Mv%zq(4(9%IJ2A%Klt}HGv5R2 zr#Bj~ZZeK_-7VCy+(zAE)*BMXl4D$(iK^t^UF&Dz%4D*!aSDykOogTl-_OS{3eE9X zyhdbJ4quO#O(o6JkDlqh{~VI?pUsloJW<434dFRtdXXAAFVtAaI@5jn3w=JxIM4gI zVJkPPIN->41CAEyF^k3m2D`$Jj`$J8n?-R~5?x&Wo zPYE1ZYLELp6gV4YhueevF{TppkS65Oih^Kae!uvB05)IMqdsHTl(N)aueJpT67*k>k$K5nlqmM48S-9Q^P$F zLmkO3au0m|I2suh^>93|hf=M_vwr6hxFrp?%H%3NIakO$dHlRIbmH0Dt9~wA{!kCG zUM?1X&Or|M?1lH4Q}od0a2z?iXi7&5#Bo(v%SzL}h5 zr$7vh48Yh~L0Gvt5C=8~;K4G^m37tQY(8rRS^sf_di)!zM?rZ#J@3=7`Jx4nn2&hp zTTme)4L8=NVf#tyyB9N0p3FRfI*lt2@as7_xLd!mjJf0`&7++qWt^A13Gk7?wr=7& zM}bvaI2*^>PXS8c`xXWMx?U`^_tX30Z4frFW-=r&7^%yshq#IQ`^Tx>`$~@$)0oHc zT3IWT5t*?C)%U02VAy%gJ!pYvW3r6)=h4YK4Gzg<7@u2_?wpHTNx7)KB^RH%e}cKT ztAtJRmO7_hL|Li1bZg)()+SBm6!Y5>QS|nxXpe%Yye^q`@MWL)uh2j&-WZ7E^#jp) zQ2_V&AnLjW;VEP2w@Xpz*M~KiMO$!oksc54QCDb@1(*4GP5Me*U)D;F@3J5;kF^jB zwWz1$qF-hXY{PRAW@D`)oG~NGO@82Jv_$E^XtR)4Hg1z=d9KP>;U7tf!a&l=JBC()RER?i$&kKLc6ai%3T z{QFpNHix=WmQ>uTnMR*^`f@9B(PIGpRohYX=_I*?Nx5+CmxDpnuRHqNC`%F!%EE#} zGIWPo4qT>ZnV!Ab2<|}@J@MB|6>CQ-*e)ocu1n_q0nhhk=(Tf_e4I0NeY-^9`~Wkq z4>n_KGBwM2{yw5L!}}L?S^e2poSTJ;Q|L9rbM4X3)b~Be^?yvE*}(m83}ePCa$jr6 z$+cuGtHRvKu2h0NjW$Y753@u}rT0;5v)qdz``$^7);?+s{o4~yo~TiAi5Cv!Yhk^n zMOsfSG#wTr@(*K1ypGyyW<+_KG5HU@cj9?|KSPZap7WO<$RyYBzq-P2K5=fmNfw?Q zr9L|M!{VO`&7Zdl&134s7JO7_KJQj&A~WJ-c^dUAQ_Qkw*deLqa8x|28>My)vUy`Y z(SUXP!<-ce*v96Pa}zip z=cB{%wVV%NzdLzZ1j7E+p@B~XCbgl4z+!qXonvi&JZC6&n_%c5sS0^JuVG?j)@zxTUBlQT=9xyEbb!}$7bs8K39nq+<%lbk18*>|K_F1awD z-|U5A>JokbSB05tRq(Q^@nDlDs&1xs!zbz-Pv<%4I(4BL>)&kCQOCxJ^8wWIuVKQ{ znT%Z*sE4qZ*NA70g{;57Jxfma0dp_rciQ{R+1OL>Yfxxf{j?!)5B&pq=BPMd@jtpC z|IL+6_~0xrISX9oIP1eF>6_Dzypq2ax}yyxggS$Js4F*lV-zCPspuU|cK)2J)SK}~ zqN$&lQkGsln^UNhpN;bioaK9oKQfHmS=S>xzZRz8SEU@xndB;Yh9W8G%srwTYgNt2 z@BC$jrj?U)UtA#NlBws#*Xgz}6;8jcFe_Z7J-M)rBm8hu8-?{fENFAzit(xSrP1mF zxqZP8`iv+v)U&2khcm3yMY#F(kNDK}MZ<^DSRTMREnh2VQX0yOPzCBe8HDChktjbZ z6@l60aTby5vHX$0o6_gkL|wvtsd(?hdJ`H-vkrxVdem`uBfsOHiu*muF%6~P^rK?g z^uV7z^eBwEpUU`Tg-a^^qp$yxUNr}y+UrR4DV2&bD%PFqHk1Wz^F=Y&5BWyUC$nCy znwf*9Z{4MR#vf_j$`2b?L}3PNY*RK^5&4wbyb}tg+;o3r)gl+^&beULgmnwa_vQT& zH}0wGiS*b0Mt{|v*_e^wB(=%kt*P#Z6L;yiTgrl4z4DCe%r6e>59Isk6DaS)s%zS^r!_9l*ELuiQ@m>$k2lbZN1q2hmq|4(AFh z^E%I`e|KX?**G&_)=(dF|MN)TQ3~o;rvL2KCUS!QvyEp5V2Xmejf@HHb=i1xzM*7K zA@^4}2$AHxEX%0}x-FX;YV{<&AWzODkTYf9ATOD*gZ$?EgNu`qddjn~im@h37{88{A3Ni*P|qLzbi z8pc+ouEG1pvaVmD93MwNtn<{^u0?&leO8o?Y$#i)g|X+gFX~o}g3qK>6pyyz{&)7t z$P2G}HVBDZqHy3SdC!`B|NR=vOX}+_@$p6Pa#0w^dab1%XRfz8%jGdP>B5?IdM(z1 zO%^QfPCmD%ql|Pe7N-g1DBDCMkY}^GT)zP)8i`g{D3@yZVR>)Xo)=M%a!WSW-)SOK z+WnDzXMJJ(LjQN34JM7CF5XgiIhC6)GT)E6IBUiGEXXCldEk8`iMn1Ot#YYvI3x-W zf2MFAiXJ$b^<~nge7UliuYZ%A?_ugHeq$eFj)RQ*@<;Y3`JvAw@}!-4KM!Kvwpjyd zTv#ZV$w7DQPoCF_HRkErs5Hb?VmlSef^z;yIgZpQne zDY?ZLR`h%2B*mY8%jb5!^lae%5XbuRaQbC!Z!BeA{SnEHxv6EnWzTD?o?jHkxuj&?@3ACceJ_o5f%qBkXIA6pX zzu(DJBsf@MEaf7uvkGNJM_=@`(AVCQg2lYf%^o(A@i7H5c~t-gg8X<<3Tk(xPU4Hk zlDQ&ZOyq)-L!&UIANyPHvT@*ALm646NT!hQzQSI>`1TeIcD165wT3L??{#K4bt zd!d8{UGLEUoxj)6m(&lfKrgE1QJC}(KNs?+lUp^CYajBY5%)=*54l3di#?mzw~BI- z`x$xiy^=r5&F6KPk;+*v6X<^=%(onI|?BcWPpomiuDL$S6!Df9ijVT<83F zX}3p-cL>A9U;`Zd(lKF~4VACP%I-5tG^6ir5_!XPa|V)%Y^=A%iyt|%wz1TYb2Z|` zde$Tvql3uNw6=O+a9k)>vHseu1AS-6odumSNp%IalgpD&Ni$;oxpb)NDl~POn>V@T zflFiv;>H=U?P@xE@;2t!vC_S&inX0kOy6Wc+HdkTgB6;5Q=A;#;sy)r&M$7$gHfN3 zCK{fbsQ-1Z7UTcWP+Vl4`1ob&cCEAFYX5kdQqrA1tkh?kM_t7c8F)jEX}d>^ykF>s zG7jMgwIyIjL^?|F_xkbIe)%|xdVjfLP@bZXD*2|b=Zj(E+~%EQYV2$ij)#@$ACZuO zoM;>FmZiSiL^n9L4~6w#`f*3oKO)hFF64K-cer9TA73%Rh=b2E@MI3_0rX4ltz;cu z8A`7g12(ltM`2BcX6uz0`SZgaOKWNo)X#vryVA*y+u)ZMCq4U<4zsYWw^eNmxF2U=zkQkRXqo6#>$7C-QSn!M6o*77ws$;mp| zpzw~B2V`LCW|Bh@avYb^@qVcdiJmc%Hj`deueB&S$B3v{a(2IpG2?igD5$U3VVo9@ z76a$iGq9|sLgT(XMmAMd(!W*4&VR+Tu2){CXeR6FZ^5bPVdC4&!wV3WU7gUZ-aUI`ICCyiCs2 z(GBjrK1;a1&i18eDBov?2C>qTI%rin(-lm1rJxgix?L2Sj@J{Uu&oEeABJJ|Sk5OG zb6xl;Gw{ZEsc0Si1WGkY}jxoLAp>o z?Z?0{l(|d4?6dT1_El&mP~WiTM6M&X7R!DmAep?%r_c0BpBX1@FHsM)e;B&dp+EJC zbZT=dG}Y?GN$z?jdM?-EiiX@P@52YZ$rsO|5A|0M6qv{xKB50=opf@O#n{Hrr7iV2 zE)CQor=tG12veIqnhs*;zg?av++_mjqXv-V5gA@aQE zwOG8DZ>XDM2v?z2Vi;ykrRNy$t0Vlq()oEE?#|xd{7|f4MgQ7S+@HxO zj_p9-x6|~a|0f(bzZmfM1oFtRp=n;M96sre*wbNH$Ir#qfnHzXHdHwlE7SQt+m_Ix z3Ui=alc}?2wV~#e7`ac*+Ct9ypRoo^c%1>2qYcZb+k21q!(!G0;>oeD;5uz~oO-zT z;^f&M4{V^G=FkxK)p(yIaCY&<6zVPZal^U^;i%Nf0Q0|$7d;f3_G4mX&R)U`MLo7WSzZka{ z#z}fpC0@u$Gp@}=2m(wWaQm5w0{-gl* zy1!5M+i@fLYe%<~^$%0dPD^RjY3me+PNyWWQ`iAxhrah0C(qD2rj+%&m^{AC$xff& zs#6-hsnw}xxp~RT@4ZrbE1IMXTQ;&&2iK^MWu40>pK!f$PFmMZDV@3JT!RY-<(hwj zJYX%NP2~jf$chzTY8kvfW0u5?28kuld+>`<6z2>w<`I3Ss~M#F5~J+vVvrJ!2ANql zUY3+hkl#sWxt?v7!lwoq$614bEnN4U6&O99uhqvOFZrA$WN80fjFYL%^{lh^(YWsdGvMYuR_Mq{8Sa>>tliVQFvrGbGVJ z@HusZkI;j9vI@h=zV`}d{Hjhicn)IruqyZS4_b`P zCWCmM`~5E?=G0_eL2tz0Gfc4iM2+6X^s)cjfO{?I@1!(QXP>?8Ek-!*HzIBuV+Z5h zGVZknyN&4hg={d{#oW_I>KYmGo6l*R$(ht6CZuz{zGjRVK97&R%bHg|a*geb@F^f8 z`P+zLN$ht&HsVDs6SlX{#Ev-n{%vJH=@!3UMb6O3J#uFT$~~nfBRS?Ol8IiUGBDaB z16HoP!=KYJW@b8^hGxJqkLRt&=_ngX-k#I1QeyOq4TIDJ;N2}#hS$7Hh z9_UnqLyt~mra&!6GIV#4^CQ`%XCUZ-BisvPz{2b4GXN;$)YH@Bb z(@Az!E0%{Hi{&*L#-}BV#p{#;>am>D(^D6KU-zU(fNJv}N#9;54c2n5Y^ws=1@?%n zVw3sw#pSFvbAuvz<8H_MfczC_oRpCYGORXfKFKEfQN^-(0cZQ$D)6B{b^i^;a!pq( z_vYGUtCDk46YLOJ$0m(_{t*|20{tBVP>Q);wGRQf-i|X-ul?}4RsiPtvNk-~A4BNF zFs*GM9z62H`Q7xKULHuVr9j-%2Ev^0kEw40@bHj7b&=>DZ3;lI0f9KlT8Nya*K`ek z@=u)G9PN+AFX(rXNl$7^02;7Qp{`180Xu)zhUlA7m$R?W{o&(5kEhL17*vIfVn7u7 z%!o!DbC+-Ao=N;(f=t$khA5l1?ipJgh(VXYx{Mc-ISFmq?D~+Dftn*xK zL5|AwpZ202HQQ2uu0H$2qoQ%vpI#6HqS539Yf!1tSj^lpNxcPo`S>&4_4vWsMbRhn zUbCWc^Jx@ywOBV8!#*j2rw zsc65QJ?E#XILBV^05XiPnKvC~pI#BnUOiuQn5P7g1&QDci(Tpsc9CJWZi%0ZqDO=psyh7|1R}&Fm*S3NUk|p5ND-N zwH4=Qvrco2H51nRQZAEgEXAG*bGD=ttj}wyCs#Wc8_5aO;-7E1oCzI9O{f8^4W7+` z<}GvIDArYya?p&uppon^e1B%e@AWx27iPuHpj;fB%U=E~D*|g%)3LLU?7HJ1Tka`k zYNWHgUFjl)aUPOLUDPV0=-tp*EjmvhdD~hof5m%B%OjqWq-rANH#^IP9Vp*-#mmpC3@OSU2K!1oLL+;n;H>g z?2x*KOk}7{`cu<3K1TbDgy1nuzd6vyOq-srJW-Za@Un3Lc0J&1tfL>+UZh8L$pCs0`Jst(0JNNu#5(FwkxTy3D*#o7`l0PUfBYIt zUC12HmcHUWUzN3#73}qpVZ70bzCJF<8nPty6ItQ6pcFXIrGTJ%U$X`a;=#^MX6u{DUnagw8l0<6j@-1h)1H-AlTwy%O<8wyO;T0&DxKCQ-%kGb zYo(Oc$6Y#?e7!iSZJClOz1N&i(mYH*7doq6^7sCe&b`&_Noo~XCS_#6gQPwUOtQih zD;s_qWNrvOL!Yo`)YK$ZK2wu%cZ`5%$JPHBq)8^vZyyb!Y(Ouo-DdHk&QtE1SaIGI zBdgaMU3^UPli%MxEMA(h_mU7FBWqe4 zW%lk^>Kw;OrXgO=d^5>21!r5|DzUV`n*1H-y6B}a>AjMBD|NMlRLFm$M1TYR9*k-{ zcT?dv^+F1r)CgL{=kcsKcZU)OBY7??=2>qMHMx1-a~rF|WQ`il$}lgit48=1CH)*! z*yE#yay9)eIcN2UuNggobA>1Pycg`%o#f1#LXFHH;n=7lo2b>oM%M6DpceJkYq7fv z&x0Z17+Z0K0#V*|A?*PyP*9eT1Fw0Qhji;Qhr1dk6x-6GBr@@Hw-_X;Rw zKvA**mH*4n1I*~ev)b`X^u+KnVnb#A-Jbor_C_>kKk8mbBmU)M9bOp`(#nLcM@@J& zhrR+lE7sGSs4+wKVmS4z7SN;G!ALJZYRpt&zwxC3gLp1{Rmz0%3r%oT8PW1K|NmJd zw!S0B_>|9e;T)ke`?ii5$gWE-R!s(4gPxjaGEgf%6GJ$QdX!vAd7cwZ{W39$XTVLD zGcb>AM@RPP{=P#`k+Gc5ZInSDPxkD1hEy?6owFem{rLB_DfDjO- z?imRFnhwt$8R*Hg<El;T3^!imtdDuZEcmMH_M<4AlHBW)s5ABh5l;^jJB~YK|z*fTov1vZpIK~D2 z@F29l6NGWD!FaNb`|<)ku5h1zs?($U4DRXcs7Kw)f_kIRBlR*h88=h2mTcn{dITjc z%SCbl>*D|9lBvjnY9IHbr#YxS)kmbchjd(|mJaF7r0!fFc{)!ePd)7DnOr0b=iA|k z#U8cE`rA=^%Q`&>rI!R@)rKHM_Xwh&WDr8i1fx!{9&2N%VL6bVoktmWT5Lhy2I~LS zNkgSn>g4i_b7?wRxsR!6{*BCmj-GEmxoFhp6Tb4ge7sHlrWE!IE_sM*gNsngYwnf4-`q!1%}h_?Z%nu$O)~evsa(;q*m{3&N&? zXzXrJW+qUNDE{64v>r=#MPuI&3qCSFJRF;bYmPj>F@A)R_Z%>Y*MoXifs@HJR_2)~ zD;Kj`@cleg%CO$v^5~+g%pUD3wOrfDlex_#rOJ<&Dz8iqAP?~4TA8t8lb)PzoJWKYzo{J`AjH;7kFZf`h zcD6|#zdt1Bf)C5*f#lYIsqwmsCr)~K!ZuWe^)bxPi&RKl$QeK8%SWs_>{3La-BKN# z&PSjIbIcmC^k3R&!gO*NF+z`l0VW*VmX3!nGq5@&3r!vWSGTqDvrN>O%zpVIvJP1a z&DZ5*z+w~{<#B~(iN5;wQD36}S|`%^d{<*mNzM*T=CvZ*+4Wrn&LuKN z8Ob?N+bY(=8d_5`!g*b;jHI`!qZw;hhX`Yxp_(oOYinlVd{8E4pJr`!BRv_I>n|lM zcs)d+srQgIN%A{2`FYK{tkA^#h?fn2ndK$@odaB1cj{-7Z7GRTo}bf%PF{$7L@$nV zN(`*d&+n8P=SM`KEAN?ct~$K!tiyxbI^6!EgRG^N=RIl@?=s^XuhEMl6Q;2a{W6s? zWpySJ7Spej*J;MX420ig?XnN~3-UvkV_B=eq0n#uN;9e(=h3PEHF}jS1(c*qI3jG4UWK{YC0?`)}m<(9j=k#Q8-Z( zEr$LVHyKYuOjxv%*M?l9l6B3!W7rEAnT4+N=wo_-KD2E!(PR+yDpSEvc2hB4DJ(KMbJWhd}9s&4s zG7!I?2cpb2`URg3KtJw>*Lu;XV6+~CzcOcLPW)&vHL|WnBlH$$i`>)DQcF!%p2dv~ zEJ$s~v-1be_-xBX`WnWriaFSMJQowWU#}nJErXND>6K|F8Ld3U@YYSr7b@jzZ3QA8 zaKC9oEvZHdyj`up_k{{fOb9~K(Lf}I1mj0|5bl=>LJ8(W;CrbxgnIGJF}ky#7{DAN zgp75;zZN`Wu3Y;_8g?<4p0gwkd$;mTzdV;bTP_Bl$c1`TE-IeNWxbsGf0Nv0QC3Tt zGu2zJzVnjsDQX$VTF-_mbJLBs5ZsOAimJaZV-Y=PIy2qF5d?jUwN}@AqiDvynIF{=8y>9$kNPmZCb@JdZSJ|1jTK z#<~S-4C@Y1AG&-lM%nW-x|f4~x0uK8$;I?JRs^qgm;FKX;r_yT-bf#rUFayka@?iw zYCDYGQY@=FD==xI0$U1-rP2X<5_kt9oadg2egU{$CIF3M0uVYd5NS8`_{5kR{5TpV z8RyH)(LM%Zv4qDJHqq(=4u&%u^bqg+>ZO- z=k!dtG|0kzYaX-O6AveO!CCEvnXh#i z`i=AY+yl2}>X2}renlUtiFk(f=hj2@oSO^(H%^f z$*((=COc@&MBeC3tc_s3drB4@xnGCzx(sKGXv@7hoN>!#6WKlT19P(yWmA8X+#YU{ zC$o%Fb)`|pdz)oNq!+R-t1!ET8lU!iQj(odEa!1NW?xXwHl|A9b7|yq$io^LI(fs8?u$hIrFujc~2+4pHQ;zQ3}mo4~6FH zNrh%+u|iX72JfZ+L)u>kwbj30yl|+yJCq8ZQ0i1^uSMO9*WKL}33WFJ)JyRsK;4@V z>aIxL4XF!G&boj9dFITVx6eJp(DsH9_TFDx*XLTRI6=B~(#qVnd~S;AlN}!?3+Yqc zkk{rr&&Zo7Y8V=+kC)cZb3CNnm ztfxlolZ)p%_MPXntIV3-!wmK28Mt>j9cK#Z#owB>>P8ms-*z(-k#)NbTvzX{`oB8b zfAz2*ldYw!eSx^$_QK=(q43#2AHc&|NDH%*=_`uFw8aZg&xJ6LE*UXC%!41)SR%}Y z@}1|NHJ?M+fAgOV7|#!_W0hWU)Y4E686(9r-ynYx<@Eh-(e=uHu{v!XeO8FfA_4T51!W4py7Mw z$x?6Hw63W%|B)|svb->5s0RC@sB7QI#FlF|Vt24mZjrycL=Esy3V+`pnW$5dT5g|w zdG^f{J^4B@dy^4cn2EPjnn>Tbxq>QQ7%`E0c@^s2mB}Z5agx^E3+2@_PaN1Eig(ny zC;ucbW^O2NDin%oxHmf2?$-3ejB)JG?m>UdM&!%RS;{cx ziC1IK`N7*Ev?i{sRy%W`9Ay6 z5A=5?=5(@>hqM04hBPmDM22FSn!a*gS?Dy;j9sfjkEAl*+|SA zOGHh5`1F_%JlJf+=Wkgk8`(_Gr4&jCE5OsOLQ#ode|29bzUDQN_1}u+@JI4@jmSj~ zHsYHi3stPF<;G0rBinmp(v1*w+e!|rZ#F*UHY_pX9 zJQEi1`E+|7f~@XFxOL=NuCJr4=v^pV26*Awp%7fiscLEhjG-f*F9j*{p?JX z8q-WZO)Zkx(cb8JF$7gy$TbQte&ri1j_HyyzKlw?&LMK-Z^_OHUYfn!J+h%gg=b!BI^hWVFj-&0oZhNxe z6k;t)J@dt8wFge{`uDlPyyLc6I8&#-T#YOgi}7AqoX;AXDH&fcWuo&uTiM*IM7q@X zAd4D`AwQX8bR-iuw$ziPN`+E^{+lnT=l_|)`6TlTyq{Xim8J!v?n)ohlbn}=jW}^B z3-{02$^N-TGH9|FTn2KVsWBq1SvJyEHI(RH$C4%u;wK_IZ857zObnnUKU7~ zyF*dfB^3XVjHB;4AC4nGNZ-|U6TI;H6#X1e8?j51g^x~FQmK5Aq}>~efQO-2yn^{? z@tNpa!&<&(=Zp5IC*Cy;MZZM)i44wy{%})yKe9-kTa(Y78-gKL^a1BNYqz8=S&l3e_eEEum?N|(3!@{!Mf^y3hO^rL_7I`WUx8_DJ4%)3A34d=Zfm{p4R zCF2VmM>Umyh61Tef6RugkJL#eZ_d{#Z)YpGP$1(po|w-0b542AGYzwGyEJnvFWJMT z7Ww}X>IN>1neNcQ-Bx5qrP z2WD!uzh^O{uoM0D=+D)ZK3sEM1F+j)3lq<^W1{FwNI!upsSbGQ9Do5ST2u_7w-C&D zIwnfyULcp0pvJ`{EoxJf9nSsc)VEq$PiA85mLSw1FW_97`OCg$bkW4gmn)9we>e~a z<8^pWZMQ*nGZxc}YVaRBD1HXwpzwwdq9WBa=%Vu*x0<(f%mIz2MaW z^t;rRVBY5_@w!Fcsu6Rj7n2L)UN9ru47(*!%z$&i+Gzn8Q-eBHuT=QumSAAF2=Sfj zh(?9oE(rkePM!gC^$zJBzu1>}67&8i)`}}edpOc;e@F~U2&IZiT zX>=WpV$1t&aoRIgpoZ zq=jK*8hVzYSGiZTY}YuU!cFGhOC0ixa>7%$aS|q)foFFgxgFdP&=#Lr7>*=e@svLhT&enKEFFJpbF3-!poCGg!8CF`0w zA(B7$Y%F~<;~(Q@SI!TOnGZhK9#<0l@u3zuq(}6D{ab?i2~je%jsp%}3_!Yt4$V2f zrc@?py+2aU7ujQfy#ORs)X~SIKJ$3ytlQpu?QLHO%Fyl$3IC)jc2_<2y_j!?>GCxMA zBIY|kp%36Td(;~qfG30L`ElSeHoB2lW$*s5ro6wqR-)2vEe`Za#XP>x!M3sTDV}-I z>jUvuLvB5T-W-|arhVvxx!)1jIB(3l7?1Y#*vEI%jD7p!Br?tcLmLF3lQABhAE&~q zp&9*J#>!`M%@sJl4*ZD6{o1LxTa!89wId{gHO}(k0dPGXkM&@FnKk?ElreJUnj?Om z48%6G789p)o}|y?|GzwAwGjbs3b*@)jnC#Awv1Y5c+q)|vChj7!-^vv3{?6Jwwad= z6I--2?)+S2nB-XA7_y_cL0gd5Rb9q#@%zp)#{7-JZaxca+$wh4aBRfak_V(2kB z(eNp8k=u&B0}UOY-ZY$Oa;ED!?M;I&<*&i#(W8sYcI`5ZHB>Z=I;%FiYnB^!^&VxY zwm8O6p-!%0wI)H99f*}%(e!DYrWY!aGPRdh2J}8E^C#)$^1)cS!yJjq_RJ>;N|3fA z5@g9bt<3wVlZEWj?7+U!XmXBE=%-_uA1!;X$4i$LakAs6PUgOjm90DD#mQYO8%D-S zu_f2YNWIwT;-waO=Ie{;tr`(cEiH~2)LO}9FMj7oP6)22LWiF0dGAJl9M-5W(O+~- zIr=B=Qej{cy%TOb!8<^O+e1|7yiJ8g0qiSmtwLyJB^rjPQ0JhM8LcXueyZd-Ly4tz zRk%@}ee>Ow7<@;GU$4lAuXVuj0ZKfk*UxB$5`QW<;pJCHT%;ZyTh$p8S~@eUfL@Rd zsZVWHz{d4@)*xy_Yw@*Q+!mqcUqekEZHCEdO z;o6}(hOAsxdD|jdr!v7)OS@n;m_A z0@OHFBN$H}1fg<${`oaMd46#0rD>_%QWtll=2Dh(D*H!E-{l%Sn7JVydIaa_u=yV6 zhGG18qr=NX+%I%XK)Ksw6`RsmB9k?umpV+YrRUngTG18qx}Eg6)t|NNdh|^Ft;dZ2 z_6#Ac(+r~i2G(qj^0og^x8R=YsDWOOoZ~l`bod#Yh8}OoFS57T$hxszEAoXw%!?jK z{=GJt_IUPPIMbu2AQiQ<>C4E!U+P57tPJ}Nxc9g^fc+P}(&2KB`GN=O!)QTH@l+Zn z?@Na(HNMZk=+~T|hH%bj{>RBf?oLNR$22%@Ps6@F{26D{Q2z`4d?xYl+*5q&<|1Q; zImw-Uj#59Og^cQGBYnRpW&SCZJdJ57PiCm3-i4;ps>2D;*H&geX(B6^yGVS7BN+~Rd0E+B&W75{+t$q_ z^`nCvT1>yVsm<7PWg`Q=spQ?wrgD6h1vc%c4#FB@|8dkGEG$sXKxQ$RY~n%IJZ~uQ z^C|NNjwoQ=-GUyQ7FhVYNNkv!w}o{8kNxaX^(YaS&K7{J1zzndp-;3~9x0e3#T;o{ za+0gx7D)9Z_Byh!Kh0l(o8uM8WY652?j;gGwopEVx>HWE}VVVt^I<_V1F7BokTL%Ln6o`5^eMH;xAQVBJj;*$2I#e(wXvfu5*cLLI6f zImVv!h`h@lQoRQ5_sBqv<>#)pKJ8q&(|R3eKIQ7GNEE9&oP@#2DwPGNMuk*6-a-_;Dl|Wq8iDA!k*0nhAzM%(`Gb>Af}C$I3YvUpgDx`!nCG zd^RfWqUKH==Pg;o&14WiI5I1Mf7cqbu)ALt*6hi~iqotUtY+^pb@}2j=7YV;!q5?{ z@qEfctqEE1YncuEPuW-yNp^tWHzR`ifc*TkE$hD@`&AU!^NRjR z^pJY`T!Fa`3T$yv;LG}AaqOjlV|fca8AuM88POg7G3VwKGo|fIp#$^BF1%x%jjZDX z*52-aEtJ{UO2n#F5j~2FB=V~QK3~W=9w?M+Mzcf(vR87u0y72|%e^*c*~GCq{VDSx zw(#7)!w(bZGry7Jz_^WmjN}-t5;@lT_#q{ZxmZ_Nm-_01Ij(;2x#EM4<9%_ng)dwh zaa^Q%BmJ2VZjd#&OYLzEUt@lhH>#!jpfS-;UQLd(jk7sM$FkPO8lY`;4Rv;A!@INJmpbi6j<3FbOz4@Dj4Xb3^)=z` zH4}z4rWUr4KBfHgF>=GFAJW%@ykqWn6V}F`0@&(P)Eh!e7J3j@6AjZZz-G;F*IV#v{#;F}1Ku zg4+v2NWA?08Yi6x zCCDe2M0wz%msOfrS;=$amKw3Ly&=!F&*G%lGoC3Noara4LR2jkHXLH^WMwDncS`26 zllur%K~6Z4Z%`t=q6)evDqMF~!Y^C}Tb_&4sxjMPoio(s`Mq!1FJ^9mCKH_SIN1SD z8!;m-!x2wsC~`xibnotM!s+1$ga6%1}XD~u+)wtyqgb~w%>46Z07l~@rZmUM0 zA3?A#t%mv`{rea2%so|&Yk|QS$$ekWRlar*eZLjdV5lPvWERBEjX^l_fxV2|f?>fw zn=S>QOa-!zyL1?FMEAce)Wx^ik12X&zGoeb`@nk#$sWGdWBUX4GrH^XfV^W*p5^*) zB9GW5f#ZP;<2*e!rTt%SbVdF>Fi8*3JIs`(hB4TYxg)-M3~xs!B%l2>7j!W3wTc?* z@tu3lX&u;8W5wEE1wA_W=*Uaa4{}91dag~wo!x1ubcNX!_fp~1hTdiVX-IWv4a|`_ zd-dt((KHR~zS7UTCD}xN_AO6;kABqRCZyvj_kp+g=YiMwedHQlgVRxY75iKUr{VBy zdfKc?!>$GSAI&(RoaFo-VRZ^>llh}s3NL;j|R9+WEoR!57nO(Gz!97@n7B#`IPCCVi%-b?-1-%i~;0{;VLenrK1T=NH$*9&hYIhU0(x{|Y8P&&vKt&`}s zI?17<+($BZrw)5<{{AeIo=43xYzx=iA|Jfuy0t9A2S=CCOQbQqy*v1z#7o0GkTCib zg|YWK9F@0)A<>3^PDw$RE-BdXivC}d$TnUv;oD#CfqG`66Me0cs%5h#POgy*#+VCP zP&QY|f>>J#AKX;l%;z3{p|c#=Uu34NmF&p!?54J}Q z;~tTF&e`n4A!~WZA{;Z{gyC0w7)}mg26j_=cjvJ0CDnvAb5n4%Y6@J7Q_ykqCHggS zzvsu^5YF-Oo@5!h-?D9zgYDcuZMf$s-5gcY--YLeCM{*>nD#PlxKh4}0`cR$CUMW%&5PG+F?(5p==VDy8*}f_$Ab({zVynS1bLIXAldJa8+mS&*z z37$WPr(@bnh5O}^%ta#el~dlr{pl5j`}-g4d;XLlVG5lLy-z>k`bo0vG_xdp^inCs z8Na7FVbBux&X?u-aguChP0szd$S-yZ#;w_$yZNEpz;pf$@|D%~IK_ItOREGZ4LmQe zV%En$9rj;kKk$Qe*xXJ>JDyQp9`QU%?s|0>dg&D@+|S)7XK-ENo=KiC!Gb1_e4)w@N^#NeNI)Pk^JHo@*8R6RFECtdN0fDV!g@)A3?`IzCTKgAX<09b`V! ztQ78d3i-a4lP}0oxDVXJEX<#=GOtp+TnT00z|16Ba+jXTGgatc%(XRLg?g!E{$rIW z|5b&O}>?iDD;ui5;P5?@^)@ zly^oYTNTbUR$}60zNcGUleJ15pAd|D^VHNu_}six z&prW`>3ZzGmWS9B7|`{V}|E4awHOA~!gJ_pG79J$#YEJ&F0(ZONoQ?R7-r zwv<%A9t?n zbD7`SPmRHkwYWw7q`F!MH?GwS1NHQ4*CTWquZveYwml>hl19(AxBv0~>A0;{xI3I9 z-^u%Rl8lqJo*Mrc@{A{2$dQ+=C3L@1dN40IrJ{=*>Zg>?RV^^KKRs(3F`Ks(dnQ|( zBj>{*uYAy%K7Yf%__Cfej6JepD0MUp z;CaG5P=n-T4c2#HegoI9DO<@elG$_pn1UA@O{imU;=GiDqvP3^SLG|7a4xzslRbSr zD{p+*TsAO&F4l|~8CeCB+oI1#x zSQ9FQv;T2P3aSUD;P}22%;#GF`*t=ypUFlB*9|o})YCO{(2#5X{cKdt3D`$|HqDWy?+m2|z?UQS#wO9e8XEf$u@Al|EW?<^4h+5&}B zyz#a-`zMgaXAMk%j6)QJ#E%pFD!X>IqjDuan+Ng|M>(t7=A>i|8hp% z&CV#P;tZSPO1$Gapq?Ey=Nt54UBmwNd^K8d9_kyU#sdpAI9qIcwNsp$} z*;Bq>k8S1Xr_hYvu-xxXo0J9z?pJfmrs32)j`jWIse95Fk$;{#m}}WH)+6$hWY7b> zod2Ykt_^hJK1MIQSL@~H5i)PQclK1XLQ&J^w3aDfiJMa6L11PSb-hHv^}qaDMK}{r5Ne*S=S{-`6SJ zM{!>4M<3rJ^4=#D3U~Kci86xOUy-TwD^SOa#rg#KOaJ}-tTFc9!!;saiRG3~X#bJt zw5Rm7@1e%>ne-6psK(w<&WmBxvX#NGE|q}6TrG{pp_0ujM~-n1*RdH-S=S#(zOtN!d&>(6BJ7`ArPRqddNUeA^wMTT zoXp9l-k;zEFO@U$HO^djTu`r$3xbCS;rkag5U0kc5o#!JlGVG<9*XgLyd$gEyx_b=RUw4TbEXAcYa zs;85rRdcOWs}nEt=}~>IjZUm9>t%Y0GdTsGMd{DDyNn94AC*M7ozdl#8s2<{;u(SwdZdB-waUCr7*JWJWTxvbgV{~Tg+SlzNhU~gK_i^Q-B6~1p$C=&&BE#=ebd|6%36W7jjKWZ={g&f@aL-i#4eWC1SpVEaU)P%`5jlG+R z4VP+)wj#Ne8XlNAf_&c;BeTpiac@my$sbTC*-Jd((J2&1uNv_xIunOnEk!vdR}SA| z&T=%lAy(y|xM!iJG?KgYgKO8vgE|+pgT5uhZasO)j3%=C89Amue4Q5|ykABPe9C!# zNdt*^kt?mAc;N20K}~x8C@dCH=VPRSPycYov3r>k-y{pU7VeXY0WLA0(}pSA3Xk-A(KMBZ1lTK zoV08t8C&yYGT5_ypZwz!a&4W+CziI6iTXkr?&gVU)E8SGVt(;K`dwNz5l2P7Os~b9 zo6gMV-J6WM{?ys()fZFc5*g9c3jsqk+}|@__)jJtr#6j18rrhp-`T8 z_aK)=|Il&CxIUSDZWk-DD9M+RuHG;n2}Mv|GTy~x!mfWqu~rnx)5-LyzC_=^AaarE znONm$Ew0S@U2&GV&*~7YxNJm)Qkh5|*+ed8=gN`*4{V(miu)->G~spla;lN^|6rE7 z-8|9#dFup@iUha{uL z&P@EXuP;3+;Vfi)ImCR}S+ip{KC z2|LC8nsX@1@_E}eB$GUHBgy`oFZ=G%W5bu+Ss-~>Kl=LR@_xN2k#09VaBxp3vgjQV z_LVvHVa+9^VS(hY@PJ3bE<|mhk45cl3?T2h;X<*b9cJElNeJS}jdnSdiTH3U89b*% zoU3{uO&?0n1S8t!0zouFRre;j_7(^!}nB>kRha z2WKME&`dmn@}(F3D{V745Bx}mMQQFsG8@XG^2HLN^+dK;D00YO2OZ9WYr4IxI-V=` z!#uHiJh^WVa+ejUi%ei%a~TCTPT@G^yyR9V8BLe-JU*$hI1SGuvqWAvJ_L`xFhBZ4 z7XE3P$+yP^^2M9^-8|nw#!pX^jnL(=ehh)70Y=WMjIvz7~DmP4T) z^y&>o2PgU%_F%p_`O~^S`4YIo8(*n2S!t6oE}uTCYAbmeSSX8Fv*`7S`RrSa$mH`p z?s+{)(fyN!-}!u&p&#hXWGME0!Ag3{p9wCMti|+43841y!-&edObqa{lWlwRBzpsW zZ(Yb~-b}{N1H6y@>dP;3h?~g6hE3OC0JZ?vx61r4ppJw`X^2_qs6l*3CMFm|3)kE*-nR{i^&<8OYrk-luXk&;K7Oj zY_Qa#l0z!0EH}(l;9|M`6%h#WH%8Vdu z`YMtuOy2L0aii(+q)KJp0&}A6<7Ij)`tkJ)!uk>|-px$K{4r)YHjNUWUG}(KKy5!< zi?Qv~U@Xf_ijOg}`LPqGl8gLUiTkN_WFqJn`EFpW)STb|=g~p1tE)r$B63eZ_+0&n zl7TC^udWb?!VE3S@cuqIT!J1KBjxTh2ka}MALVd*QTabcIRAYMpNA|D2i$rbh)7!< z&Ke)1RSkNrCr62nyvyb2K>Qq}#gEy%UwZmT?ur%rN%V6J2*iOR9sH`$H{b*_PgX}u z*G`V`?a98V8(MVxLl3Gi#mG8HUTn4sZM*|aql;BZrtfF9v1)zk>rP_wa5g^3!>h>Owk`?>@2pRdFfe;qVC=$$a!jH2>!QYFy=7JUEtb+mZH zdEkl*`M8k7Vi#)JH>!{2u+^Rkm1pzFL6dpJK7zb1dj zUZ&7Su@X_ykzP#xs1mBhyc%ir<|{!A$DK`m2V7MJB4kTEbEF@`VF35%^`j+h1G!f| z52d#-U+dpvga**>uTzwiucgGM#Q`vr1zNTu74P&VaC{XbQ${KO$7P!u@V@isMn5P) zogL8o-_Cu?RI zhsgaMO+`{Ka(v6_2fES$Hx7^+C4c>VdMd7R{&~Q8?;<(hDdz$Z#P{>mgY!=p&Y$t| zGN!Zx5~$mLir_pf zBar)S+x&i}*A7;-;G&a`vDLe~8{alCAP`54WroAGmLgezw)tqVeRDfyTNGER6>(?A)+) zzH#BpOoP?>{e~y+UKv_#3pdQ@P~CX?RiR=0y_s%%FPt^3?z7v_u=ILElrq(@P+8YF z?ZQh#$4(F3%4!E0X1||kaCukXP+`8mnQY zv429{e?g-Bnwmi7F<#!LM9b);SSccZx@1v;G;fk1DZjNMvtlG=Mx0z$#7a`*M0rCl zIVgwU&ph~=PKi>jX@b16O%U~)7%6zhKGT%{(qnp_4zsJU*RwKvb=iO6 z(~G&)S~87%{hf=c`(M|iALnZ;TlTBY)-&&oo;>^+n_qH`c&o$pEqV;N&Uv*v{T33q z2JfW?|D8TKJ((+?%g@{=gvX`9ZE_k~PG>D+Ed3KVrD0KddN59=H$x_QMru~0BIu1U zJPmKigNMwZSL1SKdf3y$$A*2LbE)TVN=MzCH0DM9U%#h)Rr)mArsE%9|4K16LH_$6 zMLG_TCP%rEYi33Z=~B~48t%50$e&8-v)Wz;oN$maOPk2Ee$>|=+RMDx?D^8#O2S%8 z@xIzfuI+6uWo;cr$IR)juC~(6h2HB`o#fs@N4Zq2lBoU;GJ0q;i96F&A`dtV@>@$8 z>eG8WIg2lO$dPVNvgehvj7d<5-pW=At~Qgtds~p(c9e}gGcI1nyq;kS3<)wz9o81t z@_fIoQGqmBqQJKS3hbaq-11!|5uiMB*`jyDIOtX}pW0s&23vyD-!e#Ar<2>rUBQ4O7{c&ZU7RdP*W|mX7s?W4aHlH?v+#pB}|u)=m2Q!CcV? z2U#mr<$%LGp zCe(~FVb_Kf+*nFJt2S%o7pb3rW;e?RX70A3S3o8DC@eAIc@}%y_R$yePBPk`Nyfxg zWFWvy>r%;3dt{^Wa@K3C$r(0d?WO@4#Ch3xUybZyy=)A9nF*gYS@_0U@}Nfah)d4G zQtK?NTa%4jN2tS*2bhw^oRf<@+r?$U!bDHGB6>TnV>Uw!`yZcVBj;2$PTbAHwSTNL z3}@|y`bb?zY9z18QLZFkFpK@A#%zQcvv6s#i`dt1Ek*2WY&P6l23fm`S0872vByRt z;3Vb#Im)AZ&eH9wjcCpG66bC$x9hX#?X{hBo~DwFL@Q~$(?PC(v69h~9OUqUrji%S z9$|jI;AJCKzS@d&I|m7@$Sn8)PU7cjBQsY!%CZb+nYpWlOcq;dJJ6BY@2zFzNC!zx zRv@_#^Eemqxvy%LGh`X&tT&7E3>oh ziFCSemZFO6>n=m@5VFIjv+Uiar(=ZxdYm>e%c{c)xb?O`Qd^E)`kz+p%*=`udOL2j zK-i9A2~m`YKiT5QJ4LeM6mzVt=nHkq8^f%8Fw4~!`#zErZsdn3GQAZez1W{k7V#&2 zO8+sp!=D)uXS{G_o;RX4F*7vQ8+qk@v6k5&J2`Iht-N3{+!w~TJ}7uke~j;Bj|ckx zFIRK}d5A~Z^g8Y3iytR^(6WXvChCUavz9;Wi#Mv!AM3#sdPG|D`S)htM}7z@kX0BO zsv*;_LA%l#to}`J#qF&5Xqa0vUxQk#A!c(-)h2V2u#sB9P3A2WG0)v93@QA(iFzK~ z`SkMKxd{h8 zA!Dx7*RcsXWpc~CZZrS=F?~rFFmrkfGlkO0BfjNxzbFf;<5}=nn?)}I=CzTrS-}4{ z!7m%n&Ez+xQ5Pk*v7>1=mUST8vN01a$}y8=5c@T^F+@?hX0?hJ+xvrW=S>z9I_EzgMF_NdoH>KKQQEazPh;b*J!u&2a62- z@~65P!@Ugk^)Cz+R{Xq})ndLOD(8#A9R9)3;$X3%chx0^)qYit+dZlqFYk0PJgeBi z*x^APV~ti#jJk504Rt?FbF01bm7(*QRfecKC)`dQdvh`WO9f-VHEq|pj8|P;u9q@y zG$tBeUYvDdfw!O0GcVg<@Y8ka+1Ak*zbIZ>M$@ZgrCzk^IJxstCl~W{(zhg5u6~FY zTeo=md_Pf2*P>oBE?SdK`VkbP}>Q zUd*nsGWBqRe2&zK<*zsisH~OgmU@oO1gXHE`Q~YytS^-)EvD-v%!e$>GQCv0?S!&% zDzvZfgcUB_1Flj+^TP@AdpKeLK%Vn!IHS`p_AUKX!Pngp)BZSO;ZG+Vw@~6f`(k#R z=&N{?eS_p1Z8qOB`kI;p*X3+9R)qR+9;Xp&J4*9N^GSMN>6ex zA!H#RQeWD(hCNW%RG7?ur%m?*fU)dJc^Zh#P1X3jMvWiq$R9?NXB-s>yW}90@Lb<` zK@fKP1mPijrvm7wcz=HoPB#z6kQIRl@K)ocAA4l|>E*beIn!xsEPTQ}AZtl}w}arl zf&0)(^nsi}-$w2OYw`P=omQi9I{$ot*#u6(%*j@x?jL3XG}ggap~Jw%%uKth!=GJx zROzULu{1ptgV?Wfn_gaddYt6GuM+ohvE>rrKatr9(-Uy=IXzppvECX=*3n)Ei>f-r zvj+P651E|>^t$rau~$})rmKlSzEcz7^^chMC;+@q8Iv#2(OI-0Sgc{zTE&`yTsV0@D$5mA%eY z((!F~8Wf|_@nb?dOh1{!>7R!7Bj|&sWR_~Jboz#+;Ylm9D4}V%>(30@dg=5EOvi({ zjh6&AA}fu@N1|KcH9YrihB}W%`oW3YH%j>zpP;TYiuR2 zN6p;*LJFe(k^O2!|D;Rg4ZO0ELjEIjRSwRK%ptRujls^$yWi>{C!?L^`JDE$RI3u# zAUo;W(LpL*x4@KO3v`##_;K1S^~lGa%~D{%K5smpGz`TNzKD1^98vxJ;Jt4c0=I`D zU|<-ImJ7$`N?};ga5vuf48yuMmr#xK;;&}RS=^a|XJ!*FOiRHiYWMqv9!{Lc>N)4& z=BjKIS~3fg-pb)FEu>jRl{9x&iR`nHJZn3#9;d)zUklEq7WgvO0^b%{;PoyA#!vHu ze+@rm@)}*A;0yH_W_J4d!l_g^a{n@KnrlTG*ADL*^!Du)hO_hN`=w36&}SwL;oSZC zp9%Zla&N`?HIY8l)i@{5xX4^(UYk_1Gp&y(#X`kwaA_rF|F)4gpY3JvB<{nPmcqUz z7U)M`soL8V2s>U1o1_#ra4o#&<%eUVe9_0&7c06C$Ekv0=w}^<6I|=AZwW<%8Qc$k z=YF$WINoeZW-lvw!7I$`Oy-)B$^D)?*O(F67!kug()VnPw_r{tuh0A+S-9QPNpM*u z?t|OQ+}`bE-evluopzA3mAO|>D}|4z6*zi}jEcVn+P5f$JA?hOq^B>+9`wUqCm)RE z^(vlCzevk4m@kFFMXkZ#KI{WHz~`x37GD21*d`$Jxz@%U3uQkC3|5RjGljk@TzM9WT+l_ zdlInHI{|Sv^loaYNA(&R2pW@)vpfryzMX+%7XT zd9d%zD;6HKG$R)E62)m~mJdKLuERJhL^qLm?fogA#4 zBr|Iz%Fs4?>Cr7o%QtD` z_0NIVMY%VKp55d=gM)FmZ!mol^tdr50hxDnSf8Xv3kP~MX7l}Vy|K&XeM(BlhkhB@ zc_$tE3uzd!i5^nyGk;pm!abfG$TlZ>OZhQxb$Ohuphxu8GDifhnfKbCxg|a5dGXc} zvCd>+-BqZ>eZ-<5B?jg(+k-q)qvd3qCQ%cbNrvYdwVnVqnm*R!3ZI_?)M7sEO<=vB zpUWqp_v3Vwznz9hYtk`@Y)abT40=^iQ(2*KFVj)sZoaB;k6o{D|FlivK6{wL{p(#j zxsujZ-u8DEOO;C2am=@#Ku@c-oNv07!lii%IEAx^vYP_GI0rT1oU?4PFRX8KPFDF~ zZ?P{tcs|&9m2(X_v}2KB*q+S(qzv-!l{oe}7lv=(xpjOB{@qN$LhixWk!{?Nor4bj za}de7aLI%m?CQnL`}Oo^yxU4NQEkL}gi1DDXeDib*hq`|c2eyIdoP)z>`Xo4)Xx$b zQjgwxBP>vZeu%B#`yr6$o9NA)dmd0ELJjf3x7Y$=35YIlV zG(N!`V=^+*=yC;gc-i&J{&tPxB zK=v^`au$F8mQvg|g;9q6g+7=})3sg3+#X5SMHX3f;##9s}yM(PhuE}_M*WcKdx++#=1 zvY6gw`Rv28&!+ziy>mO{U{P@vy3C~K@kRdZmP#3yZ6l2zI!f^`2YHlaBj(lY>C3TT zCb$CmwTnc(nEt*s6gcbVgHWRrWf>uFg)(AL6V-?*OS8V zaUOdXmR>^7N7ON{reFcjT#4QId2I?>x@O}5ed(+4I?bHI_mz>2{*h$iM>|Qx!dCKR zZd*zF=pw%~%yDhhMn2Uf`!HSs*TWXbyjdu2nqrxnTP)2EdLtmt8;g(m;C*XfBsBlRsLQp;7Tk+_gr?J6~DgwyYDwI2K0(O)k*fi)%eopVpVs~`b64jJsBNQdRn z4Cv}`FWWF3b-0ENrib0!LS{M}6z*L%D%_P_I9F%TUvG7ySY1z&{A-Ca*)u`X$0SPH z?gVMp*cma0S|IWwna1kQm`4`=`zU7|ObtdZd+5D}uwTAYFb?L>cZO@)+DFXpxv9s5 zBg`!JOu$o(4lO+rQ12Q2b9d3xwSCY_6kva@1zdg|k^3e?;E9 z4zJCN6-i>Tk7v0KiPG;;yiA_27njE>tW>u^`*!rLOyhcSPzB32&bW7ny#ZaxQ(h)B zIGgjdhG(2n!T2{n0VmY-tIXG<^;`OX>|>2^a00Y9GvMh*u5ubVJu9wZTj|5TJRSQ> zS-78>q;S7S*7Kr~^P!8v{U&<_-X7x`Iv_!2oJo|o)sM>7)=6@uRFdr0w7^jAH`=ie zt$R&pOg`<5X;YnX!G?@^C_V9~1Y!L2Ahi3c#?IcWaQQp6@Qw5X`9zI;z8?P`>dom?^;cl^xd5H98JjA`n{4ommRo2X#c4c4R-=h-D zT8M^BV`Q%+DGJd_k9lNYuQ;QLyEERg#&FlN1zZ<6qr#tHRH>lGi=}F$R$PV8Jo~8^ zsgdWZ$C_N8t?KEK@k57f7d^^dps$CLEG7Mp!wu=k_?U{e)Ydb$^Xx=+FoxH|F_r8= zw8H&5uTf+adlx#=S1C^`%O)ps-x??919bAxK`#-%oZvfLg+{HE%!i~mbX6t1YCGcj z3HD8_{XeEreMgP4$9R@aq7QR4+0M`OE%8af%&$5OAD4hrWKmOZvVPc(e$YIRb-tDc zk80`kGRQ!bkiqA=KA(FHyRE!m?By8E=lZ`|*nb~ZeJrI~26><7-nd{Ff+_3+3v8c> z=}jzUO!Yz;7~z3z74@p>Hs*Ad9w4%EE-|jm7;o{mZPqFnn7G*+k|M7iYrbc~dDfDvv#veQP2NzmEE#zgndn%9+?+?gwA(Zk-5o>m^OX?|YGz@1t0uDC?w_RV zJyGgW2nO8?D)!LND3&htSUBj)_em{&OaXb-v5h6QMxiug-t?Ctp;*PU__JG? z`2CxCvSa^9nf0FNbutv{b4Ik{>tq`(<#6`@L)uyYMU{tdf52Wl0L37b2C)wV^WSEZxC!&XA?6pPCsa#h9%bmejD*)b?Y zmGfB4-EL?jy~tx0lYbl^z-L>p|K+xQ$?@}?`HxD1enoE~@MdJL>8-vOtaJCkm z-RAV@Ju{P}Li+5;b>1PDTH?ffbCW#SG`5gnb%m@O;fqeTkvQOzifugaR=nQBc9zR( ze$FRci@~5j>a;D_Ws|ZZt=W0;(YMd(Lj$TAGTK zk$IeZ<8`#AMC!NohN20*t0!2?-AF!^xyCE67l~;dZ=B%qpZ#2q^DB7XueB06S1h;O zeDIHD1a=hYQC6EC$!E>PwN|kh{_@7BIgv=|!TyXB`yFkY${Ky4n0*|9O!AC_caUR^ zVz$*AE2;cY$UTz}verbxlN@eoQZCNFZ!Vn!nLoaQIq4h8L6e(KBd44iZYM<-d4Avc z;7J>vmqI-nT+c(}pcYbiw@6(69)b2FcwH}GoqJaqo>&`8%@qSCkGc_ILnqIqf~m1 zz~e^|aI++rx*!)XXW2-8e5tfg^+nAc5ilqBU7+H5zu#Pj4JnnYj_gs;dmEdrN7ORr zYj<&!4UVPqrjs9P42gglKhKww^HBR{3+YIHS=rqew%m`-8kmZjW}N$P$a39`MqOIudl*(0>${VjJMuhXyW+de1}r)YXe^Z5SHrK0a5e*IxfF+W{M)|9=? zsq}9)O@)fTZ{y`w@*<>A0>As>6VFSFEczl(=c4#@3u!Z;SZca4PwQqR0(|v&T$#%( zf)-?ROJyB7_sPp6u_9NG^e0QtE8IIKbRow+(=_n0uuxu?Q_8yRS|tP)>tACsRQ9Pv*lC4%a3uc2Yi?-lyI z=F<~rN-yE}5JaCO2ULarwZqI6J(MUn%Iu(66M_qaROqycxycokQ2EnGO|DQ@grX0* zr{1H|$x<3IJt$F%=ueE@77XKa@=CQcFk_q%u7Ss7<7r1sn;nb=?BV-Za$fFLC1*U2 zai+l@ny;bg#M$KT!m9w!S=*yEiK`Ox=C|C80&eiglhOJl@muRSyD$Vp97<4XNZM0cc@ZD+jP z{KElf-h|K-slpiYM~**?81ng;RM|p)?Rp4vy_2wF0{2rkWSb7zI%*?SebhG)RDGmk^N1X0t=8Ff7r&wW+& z#xvJ@hY^?dF^~JcJyOqwz;!7508i85TS;GJK#Z)+vZwzi4A$fvt=DFtdqE|}9pmS! zwF4}xv-h!Ag@h@Y*m0r~Pv$2`8FRYbSBGNV8x<@|>IOQZj;4zHu4qrn(^R)zMB zS;HGap0P)qTzKV(r1A8nJ|QnQAph@Q2|IfVO8uSU)ij`Mx zPB>p94FB9vXwZ?8vjjaF(ffFh95CLuWrB4{OI~y;bp&+m`;p2mJihRbh7x_HFta(eQelyn5n* z`wf_99gu{un9$d-P0YuKKx9 zY&B6KQOmse6rRVTcv;KqD5rA>^4yt=^N80)ZzGP^j+Zv;c;841Mb)m%gXxfo@82si zm7HvgP03% zOOBGSzrp*!$T4x!q`m`|MTB8%eSS_>&>KfSbPb&^KRP&}l>GP}UUyr!Wgs)qh}dUb zkFGgjB;BNm z%P%i_v%z!I?vJ`>W~Ta?lmFDG{Ozf0y8o%JaakR`*I$3@77cOGcRL%S8$a=E&lz7$ z^p8z0>7FhcsXuIALuc4M-g9XCs+Svf+n_tUYNKb9^Hw@z$1r_O(~h1dmpgfsulrL! zc6?*qf!qJ;F4qXZw6oLs%NOX)Ng>aedrT!Q7bS`LnB$UjH&M=9P>Cn`#-|$+<=jGz z^#4Lnsds`5nVuvIKXcZwaguDEA1^yEBuT8FS~g5%zncAmPl`mT@;83X(MmJ*3Wgc^!>|D_xk`BlkuK4xX2{s8%XwZb26wxkt z|J)f(In#ONRw#5)p;+3Dvy!Y&`)p;sYHKKJ^I6}9vk~Wik#}W(dd5U0x}0I%dVd&x zc#^q($+~(iGP_rlu=~gyB-TxC_f+CavoPdU56Ag6^!3c;-#M$qJ!d6$&*63cXE^h0 z!%*SQ&+ayQcnqwOC9x*X+SG1aCGtF#SjWB5yV@GG`=Eg(dnvVT=&s0MFWQRUoG0Y( zn`p3{z2@aV$s7-7_R}>D8n6a&H%N+$F*HeyPu1w-xvR!e{+)@Z==7PX z#{2eGF`96nn)EE*3+P(fcK2^YW#VEnSNvyhq4yd zK81PEoYyFt%X-G)EL`8mJ=xG~__fbOI&1Vhsxc#jeP^>Tnds1sb)hGjSjw7E%y>F? zqOxFb#x;ZWtK(joSkQy>x&O^BD>Lz%b(;G}nGLm{f4@8X)04<>U&zF8YwmTdvM}Lg z79Nbu1UhCizs+8(`?r+@ahBL{H<@kYCVQ$nN$+NMGP8=al$zPd1kODEeZgKnY-lCj zXWB_M9~W^Cw33^@?8JV!gPgnNESriPl)^hT!y}W+h zMgr-q@n&t>pR?_+EZJ-IvynBm-NfCtwQPLMezduR*mSIv+EdEJzqe5itmm9!8+sK} zDp>oklp|M+@<)H8Onaq3@C>8$t5Yt=nk%3@Mo<69GFjNUTt2K)V12hTnK-smt~r~a zPhE0X4(yXosg$oV%)`A_A^yKB<&Vt@9R5aMjyHXEEltR?Gpl-jr9^kDklqoMa^;Z% zveE?ct9wnVo<`j*JR&+12 z$Lr7f(U7rG_{LiG@HNc1UBo(86#a59BVn~M8q==RyV#kIxj<%5vlr4bggxr_l;&XF&w^^WT^8Ym3%LqtW1K)EYp~KnDY&M;UNql>tij zlxuAjmT!8riYW@+%FiJPc_1*?^>Z23Q&la34p% zPAOT)v{YmsGoafKIssx+(fvE?9_gu=-H*@BW@)%PleyDB^%y~}OXru0kF4iu>!hLJ zUjy!%{?}LMGvZz{h#}+*?Ab4F#Qw+@G6=VriNL!1fVK1+^vuWR^LfZC&d0tf1-Q$) z)4J~Y@Z@Wsr7=7A95bFe<-u!k9_CsXVAYF!W}4-pK$!>YbM(r^=Am5^_N4dZNX0B_rGvD1MqgtIT}aHJ+^-|s z!8%=mC9j*}3b{XxdG0&PW!7Z{{VPU!Raq{3(-rU`2Rwdqh0KkslwBW`MsFz$eVIWy~>^!b2Xc>-{hNJDSh8pNZUmU zY>72Wyd&MK%$s)2QQ%2u_7L~_BJ!gjEK->fwurgy2LjN`o}YVizjetOzVP;k(aayk zCH|=M!51s`^Sau@8sJNRbgCM_enbEokvYEgmp?A{VK#hi=CZw`i;MMvBW3=q53sM4 zO!sMje|+UL`svH`VD0zEb9ZKd75d`PUqJ{<wPPjo7 zdW_*U$$nApE4sgU-94#FXX>OVWb(C-0-~^z|KIXm6e6y2W;~Jp(@o@#hesnq8I7I% zJIiX)?{tIL*hkKnvbNSL+kmr5vcJyE_~iApwiB6+5xjOP=w2B^H`Q5wt(O7cs;A-X z83W2E8-THCm_Cy}l-107<8`JV!fUk=ugz2B78|D`_*p6@pG<` zk*fh-ymng@@%67$(QCAUGYssh{m4h%SNV7_K94Lj{UsmxxhInty_P;xW};b>&zRSo znP_eDq4~@l>YJ<|Ud=-lUW57vtflk+nN8&EI{!{A@;P_PY_}ltLB0hT8kC2P3-YjP zTRxgrqsQ?}9$t^+b#ycz)_Q&|f!E+Z{=9$qx~t5cc3-SxJc<7Lwk*#%+iPF8od3c@ zce=LjVZ=S1`?_%b%IZ2@%iT8mULN&58(iwCAJF`&?$E3+x>kOhbTw6tJ%)c;r}J=` z?%|WYMVJ3-y@&U}Q@Vf+or%Gm*sl=zNTFgdsrm(6;wsL=1 zSeHKT?P|^tsn~Cemn+U1u_#cBJ?jtqdyq#os^oXJO2*w#$s%wzW_q&h&EnrrPLgcX zBq`s-IZbt%jN|vUaz(qw&RG4>1u@(QHmO5r1=$IZcZqxF zjDxpb5WziSQ13A8cUPiLeeUzDnJYPo`?tDbuwY-)ezX$N+_x?76ppNY;bd{>C26L_ zm~r%4^-yB*3py4jDly1`E{>*3)E*Ry7sA<>+05o(eW1sm{643YSoWt9uGwLTJ;HqI zc62pb)5GW(0$(-vl?}t;)HNKRxyL-di_e66)wq+O#)NRrp^)8}^o@**AH65nG}ymc zO-C&KFzk)l|59VmKn?Qz>Cv*_Ow0fc6!q!t{+BbZ%jxarY@^3vdb)j?ZPr;0ud`}Y zyQ#+MwQ4kZ&Hn5;HS71x(L2l8nNU7wr7_$34(llFw^hmEeA!ZF4Ll`3xtzImAhCHcwekb0?dq&%*auX3Lq;#p03$PwwL;Mlh$9Tw`n;=Tx{qywNZl zPf{{a@R~D{37K%__f)gj>Qj^19Mzdy(3ZXw`z$Q+qTgz7CN5v+JdBR}OFOzDyU_pW zPcE`L_mk8AAJ5o+qrIe`bd>qmT&4YUH+j*qv&{WsD?XtLZ2VOwBk5%zFW7+h zvyp?-&>_lzSn_DAcJbOT&cm+^GS3xcpXp5Uos|#gGAH)Mm@#ecDE^z;OK+o{EcoCi zH_n-08Xa4+>d?7eZUV(}u0>=+{)rC2mvleoBKTnf_gD35=362D7s5>FQH+I|I+o0;OoBf7vQn6M5;hGs(mu3HCU$}M`X zS_NX*s6b439Ec&V(O7wlp1-NlSkRq(%7bY9nol2?!hp*8Y52U>z~_!M#H_f&%ohVD zk^^6y!h3I4KCX}pDR!rWT0`bw5FLn<++{{}XNllmd(=-CX?vZl$}Cefse$?2hky-_s1`9W_L~s!s!ixaOoJ0rQ^xV*wPsZI;F^;wy4ehpD&ry zyQ%ow$o<|s0|M5j0i|T%6Z0@?Q2}~~=VKy|OX+jYe9S4p$K9^d+p)8l)b1kJZRub;@@QfBqGEiwoETJYayPAM>v(^YL$Ot~sp=;IN3F8}9L{ z#TKBSlcU@yv6r=KcX6uWC@YxV`S5dVxmvYC?#?j5ja~}eBX`;$M!|kBIi5#>_~T9> z_xyo4d(|Jq?*&5DIRMTEI-89=R~mkvdG0K@ANZLPg(&h(>p34V>Jn#sxPGQd8oX+y zA!!$ToCi5qqsm8ouL9QF=^P%Gk2$^?*)=UuwiapRSB+%m25P1EC$)_F(+L)3yhpEf zhQnTGT%PI%Gh1i;T*`dl6U>~BQKH7PaGbFT$3ay%Iw$iPGlp|>e`>KImu%W&Ey9yE zaHbDvAMXnX)Y<5MGYb=W?RPm%PtjcZnp!hggu`8{3ghfD-HdIN5RcV(HYOY& zj+4)8#reQlTKW+=4|tFF$ZRr&ZhXEymdW`Kx@ccyqV!27T*!pnT+3PejpXylUu+nu z@Y-5TXAT=6BC zp1*}kbi1L%0@e#k28HALrZD_GMFym;77e4-7(GqP=W{JO{$!mylsS~E=x;hfSENlg zG6wT`+%p^7SqrP0tngBhPg&lV$Evo8S7Z9EUYn)JqRU#j@1>Q9M_LK{%J+6%E9$YX zTx00ZoX2yO#dYx}^Dw5l;8Z>G^UvrYd(D0U*Qkqt+U%57pxGGYuw~ zk!k0e;Lr2ZfK27EZCQBOp6uz$EEH~JF6C&2S4u4tuVcf>snF3__dlMeMB$Z7o=ACI zExjI`kP)vrXM0s8ZpmuSCOX5*%mr0LoR~f5g4-uuF=>k%o|uK>;{0$-a%4v4StaKd z!qJWAFl{dVW2|FL)M;_^Bx@$y=`NV9LFomqA4ADA4#~pprCFG_m34=!L#J@WriH_cOwpH5O8hZOgCnfl{G9Y(rUqH3Dq2KZYjKM2r5}I( zU_&O-xVAYqc!F`CnMc7|@aTQ?DYRF3WxS^2ig~Nw$>+wowUsKToMm@ECrOER7d83D zj>FvKBA@$jIV$jJt0@w*6j0_@h@RKG>1n({ z$N1mQQdr?ATO!+teP(+(_sUJGF1M4BT0Uo;Rv^Q)QqoTu#ksZ#-bV6%nB<2xy8{r| zkB)k-9ecBaSl=Swt%!#Ckv-UG8-+a|qmbhqjRM}IOAe$lyUc*)T(@R(O%1_C)$)kOh5+u~B@^V21MYX!u!1BaH8- zpPtX?e2#Hgn1-lzY4B;3hQoYr*SF%@If`pKp9um67I4m($EbDz+PJvM!L=Qv@x(6j zkTs=wTiZ$1;7(%Nw+aUH-YioT=roe7-t9_e1~7+%nb#wF_`~UtKSurZhxP~ExdG(y z1EcXt$iLr-Mzohz{p(pYh zpUoC?jla(|>=jwl+xeIrLJwkcJ}&aSSs&paIz0!a+R4J!t}-{*S$49{uwh7BF>g~T zZf_MBzok;@%~hanCEZ%q3K(Vv;kkI9X2|(k9-oYL{%FAC^Ym3TT6Notb9z40 z^4WA=y*(Jo&&~)xuBEnDkij)x_VK-4=5cz@{E9H{fqHXRVJhn*;8xpqAc$LSMF z94%4eyC0n^$?gMZC$xw*_1$jwrk$ zPIKM3tnf-F2S0-SQ;T<6*+CD0C7l9ScN~{hj%qo^bv4k9{9?KjI((#KzJ)WA;D%*^ zbka9gqTx68vb1#gb_iz(57>(v zQr#8Oo37eMZU}wpg316_ES~Lxk#0&<`Kg4C4E#$`;sBp#>J1_PIaq@c^|i1ati>fq zEo|m%aMel+`@&2ljLJg)nVesD&c>BFS?D;2nTllJ`*2;K#`|&!|8)DQ@cI%(ZtwL8 z88lxbSLP?l!G0R)`-|-0g5y%-kqb`tbisri$1xTkap`{yan}=gsZRR6gq6cV{ z5?x;^(JV;G+$Sy6ff_Wur^WOY^j2nQn6<3IR5GW3&d)}cR~E8(zOn~rY+nyDUt+F0E2{b>OkF-@*4qmvGLWWXZjfB8AOVVo_Tyo4%=KHu=gc>@`>paK?<| z>|+GD;7ngS8<&M+*bF85MJnMvMhVkGo-58#jOR0y=`uc-jpt{kj~0_ZY7n$TgD-tJ z+x3a_8)LKJ-ktMax3iF=eCCXvuPe5$b7j4WtSEfrqg zWIszL{6C&Cu9~@AaxY{ytv8O5qtQArM|esOes*XfHe1W3)oF5n(Gh6-UXPtS^YFN= znOwV7CTD+>6SRrIvxcnWtjWc<6;0$*onMknkKyTo5ePhHfUPkHCDG00!8-cptbDNd z-$?8lPkyj%F1}Z@kOpSuQue?bQ@%#RxK58y`#g-TXek?qmoPKN2PNdQ-rA;O$E95S z`r1U6{VbGyEq(D%Xe2s%vsSw!2c31zWM+1uG-~6G{X-*hmmE_@MlO~)Tg!S4IkK1$ zI7=RC#Y8<+fw`D`wUyKvQ!bB|(BG#cxAl(PqC4}QlbK`Nyi^V^_eRTL&IN1qc%DX{ zu{vMhsZ>5rU`}gsB&I3#_;xJ^mzLF+EL(D*;ePOOVf}7!Dn^q}Y&FtSCh7`hS_X4( zH%FpMZF(D(xft2fTHwq~8F~rl#{I{Q>M)mF&)rrn<>|p9NpI(k=G`LkXhbSTUe3c{ zG?zJD%O%&8HA}}xY$GSNx+i^bUt3Dbl|q@a(HoT`BB8Fwkm|RJ#d4V++763AyQ6v>eUgjd zzgx=eH9Wsdy|Ia&yRrN}BmJ0@a?x6Dk1v;-VLmt*$h?`QshE|X%k07yl6SaRcD?t; zOCFzBXUJjw%EjfXEhTAAk<32hjXL8a=*H9|;6xq<3~D9cElT8RZ~EE>N8qvtIWLbq zyfS&&AncEoA)#diKqI;mY@OzJ4mc(^8c_hHVpgAeW;jX=xKI(*0{|24>3`qnL#U)dvYfgIm_a*+xf zdiQ?NXJ=g|)pyamH;kVv2m0pB^Dt*)BQfn=D#ZhRV8>eR97QU=ea%Hd3v-EO4)wQT zKFnT^gkdr{L~@angUw`!N1@d5_QnYEuulK#5z(CWO#5bX-J(=}_wd8>LlJm-R*$;9 zb8#`cjl7F5lA&rJyj&FtH*-DA2haZ?{i{<-A;U8qrE-buN{@ z^cybO9f|D8%%@Js#ryH*(maG-&Y3=_9YL>OV?BaisHMlR zD|vW>7P4+(sSM(EG&GkSXbS7V?{cy3TT|IRxKO5(4_!DS3ZpDiv5eR0&~r`Y=HwE2 z$n!O)7JEe>_&(R=V!01{46S&4+W3<9Ag@;~6`K$6_`5WfSu@JyO$T4xoW(rrL%eT{ z%0n&YMlJNH5X)#^JXsNmFLYMu+U6kac2n8Wgx9G#=OPv`vx}Tsa%m2x=eLkX@#QjU zg)f509lNzjMb~dR&~3Dms7-~kmUVZj6NxjK^c(ic<;=aMTx(Dw?U_G*o%gZcr*)ib z%EjJ&w(|9Jsl4mui|ax^CV63xlYIY&t>w+zLQ$ywV5k*|tLK?FT|1AnEmktrtw=ia ze3kP0{o0Fu(k8iNugsCLdXeXa9)0dG z$2`tLTHY>~HjS9=^ltw#SC`_e{yyy(qb>x1)+m>*5ohuS(1t=z5T{r5u2OY=c5+X!@IAFlmB zyq{0DmznQNr0dTS=#mmaZzzxF=N#;FNh;X?la3E@Mywm3BuzisV`=SB{K!Z`mOK57 zft5HSMKLa~DWwHN8|k0(#pB~f|}azvl(Q1)cV&GpDYGjf0RvX4pUoAeu| zGuN1Vii+yYOPov3n$0n}V{~Bt1@kC$@+9?BLZo6i-=4K3$*w!3Olu zmBfmd2R(h?!jQ<^-e>gR)weJrea2C#zR3ZzqC&9PUxndO8Ax15-c6Gr2ZlLda8d{+ z1(K(mlY#ulm6%r$FHZ+MU_bdd%RMTz9+81x2aT*-9h2%$>@jyAzrHXDA20CtB{y1Q z{!uaK`|%tZjEoN|T-0Y^)&TN-n_^`KIhBs~!CY%p*!4Iao;+XWjS}Sz^Q_Oik*{1r z&XMO=ai$WDa*oImCnvI%Ay~zH*b^1$sL{-byg%Y)W1JnfwF||Uiz;Y%9CndQD%=|{ zpZeRuXXPryk`ufhK+on=BgR+6ib-92^vGHThviA+`7&YF$O!8yv9iO~5skWqGIx<2 zCC~eg%awRtB~A*bIAL3Fdi``NELfC|_2f@W>6N=M#Q|ME2V;Is*8i-Q;e+HCR!3y-Dm&D?8w{U+lMr5#fy!Fs_?+UTXqp4UOGDr}M}?eZ z=4c$+gGM`@v{>R0Z2qa-GAB2)cPxmb7$0;!t`{3zLw^ulL~f z-qR~V%zd1&^L8ja>XG-Hnt_csj3~YnE9<`5BP=VJsx1{}@%vX9Ys9I^(e7WtT z1dkQ}G|~51u~ENwqLW^^Q19XGS*|`%Za2S7z$W=I_<@ zshXmjxpkJ_cKTXftF;p@*KG1z*WM<}qxJT$p1(J}(G7O2uD@j3TwfIRz;ol*1YJSh zIFE$Mmv#Bq?(0hbYM@`zVVrKubyI!#(;d2HtlMm&C(++5Sz^v6N&H`lGFFo$)?Kx7 z*)3VxhpOc>8O4|hDhZmWmN@1BJtvo_Kg3MH1Ie<5z3UUKGdoAAq&HoSk3y5hvs<#X z{>Yr_iyCP^FiG|*RWgGfNNp4TGlLGseOhUGCP{9Qlbp&vwT0htab)kh;U6k#w%7%m zIYXH?mptJY-k&S@-%jiwPj;dI+67OO=}z42gl3&x5y#gmf}GHM19PJJ|7QDt-UtO@<+yxyEaGl-4y1_tKykrmM+%9LluIY^2UH|33yC7-1Ggb~|or8ZO zzd54G6GvPa?Tkgm{22?B$f_HTD?RA_)rK)6J`5(DGcDT5+0KPwxHm5ho5`}bjt@gd z3VFuiVc2z1i8t&!w+!OkC+kUf9))1x>o6>D8wRySIGM{(*q*0@qOTIq*tfniISl7* zm2~{jDazNY>(JxKe!*nVP~2^z#AwbKL<-k&SJtSi)2qY#eGu15)5c^NS)+f~hjWsJ ztShLQ0TG~vcNVk%x@&R!DLucA8mw%@e)e!JPVm0tmPl@~4{IXBSR*N-ua*6WE!_9S zepVqOh1~i%?g=c_>`|!E<1+VQV>LMSo&4hxW=^-!pw)U6mX))g(~UV>?CTWG%E09Z z%#cpYgzqb^#q3us>z09;l8O93GBIl_x%~54_?W>y^+P(P56~OonuSqIvM`o47~?+n zrmJSbHaipV$R=9d;~c_i)@NADQlH`BiK4oAo@99^4 zve3^16

k(3eUSN@wI2>xvLzU?kG7;9mTIr zYq?f#Ex#T*$w1bd7p!)W?5_4=H`i6}ZnTwjD+l@2+fIgsImyk%E|PGY891vPWom6_ ziLr2!PN{Cv>ye$TUt%qJlkH^iTs!${XD?BG-6hYbjZApdTIOh(L;FgB^FGX(Hdi3! z2KhymQ5=?4$k%A*PCr#((gkvk&FO*jP~Z^1*6gn%`Da_H zv`kQ-`X2$PwVRAofgf(A1R#L?;-S`o_-j4;3JF07@9l>X*ZomtJKZ)t>5Y5thq++y zW0^my@|myKOlIP;@44fLKfDjnXAnXUV^g~0d;`$pOaRR0_+#^YKj>opG3=)==UDyd zu?xV!$^bkgU)8DDANx2H*u&Ew7PkY)Q?UOY6U~_$a!`l)9CeqTx7(aMbSF#oo6g2r z(YW<75>hL2!P-p4abZwwi&3O=VQ`E%7#INXFj2=Z7VqscPHvQN>2z5ieI zF`6*ns(}HnEtsvhlQWWTWT{T3!oDND3?0*O{v~VUX3WdoXTXfF?9G$Yn&Lt?!fyi} z_cmbAs8kHRlZrpa8(3#%jqOY-`n0Cwrg|!R_f5sZe*77Espz;km3w|>cNB2mEP#EH z>S=Ji#q4V5Ja{gkcX2#31lZ$mGMn7h`8?PSW>yn>ImhSbWBm^Pvl+9kN|=Gm{zVsC zG5}#kvQrkT=|!kX*Bqbs{j&0~lz->OOuoK6 z4+;EU_2=i|5r3ZQaX#wr%twtubSZ4L5xL6;t|9Us>79s~_(2>$|Hw`|K*mH#kc|RePC7Zt`bOH?iK`TF#UGP(F5%m{uk* zl$gLf-Y9FMjk5cy3A(x(WgdI@hWG3fRVDN5P%b`hM!9*sQp$(Z+sNLL?N$X&3{+sL ztpZ;cC=m37T;fn>eYIgLt*8IZT#9cdYY=b zF^|*U59O!)k+wSk6+c+RSnH1vZ(r71{jkR}0Eg=a;>lI!WmctM#fE;T*1l-(?}xr) z{P3iYKXl#wU_vh0PwR&U!~781pBZJWomj2*!@~A{n6@Q~_g?k}XORQuHKi!vtn%R~ zZ09vIc`SLvEM`i3@mhPzEQUX$@fUkzQ6r);V@?#ZO`|YD7X{aNW^iUpu}0Cm z4ttKHqM2L6evy_LI}M}Y#B0`Ih{C>^{5pB#F>RR_H-Og`|NYZ;`cipKj%DAgeo`t{ z_h3d)ce)u58PJUEp`|@%;NuNQ=|z_0oB>a!F-w|!A>%2(H~XC5 z@8%(b*X`@&%4^oqiaFFn>1;gTPCv2bV!dJALEYo39=cOUPU=jy z`{_rnX{X=WZ@1^!HeGdDmz(JtJ$k9TTd%+FpKF74mg?%gx}F;5x$x%H%RlQK*VXfN z*45m0Nq6_tj?1Zk9oMDYZ|(WVkq4gd!|PnCJ}N-Jpyg!VYUZ!f%>YR-v_kO zt?2(o_pH@1-Q%uW&vnkrb!m~`b@fX9^egf>ccMrZ&VF+;H2b6_YPIpwx$kA%) zaV}BT_^2hKmr8aHQ%n1oYPsc~EHn41B<-M9jOA+Ce>PbrY*I@DE43t%e?0WkmEL|g ztTND@IMf9WMrVv9^AR89f|Zk8@VW_epmQBjZ#Nm0pPWyt?S$dcE*Q(#y4+*$rjH9+ z9&w`c)EVx-oZ#M)JuVAp+-dHDT7Pq9MoEYFIVXI);|P5%@{UhA1GC))3w}70i*Q9Q zXSc>}q8Cc#ggP6YVeu^#MYqGy&?5|PbHnh7J*mx?$eH}5WR?gSj|Oz3EK$Opd$&W4 zln5dp^L#gX#dAu$>&5-z6*?H%+6#W~bmmu=@#pY0mfQI}x}UX?-Sn4n2Il=$x>i!?W@Ihq z*I_!mt?B4y|1JI+GZDD2d$);y7Bcs9ZWgARlO;*aLPhN?H2O0Wqwi&+@fmtzj2YNw zl8pot&cJYgcxMftj!41@}J>Vvas-C21eD*!jT&EJRacdDl$>yeFpw4}8hTO;&t!mILK3(q@dSy!x)dtNjWT_g0{?feETN zBL6_HQJc+q4f_D}>==l&#erx!!Jiq@fmrjNvlfVkSv7iVo%V3v~ZETv7M#G*$z@+ z;v^OmTqJG+9TR7`f8!by+s70`-)lR9?{^eat)uvO(h*4qSl}Bn zpK9hz_oOd!6#beOfr#i9h(Nw4&+BA(c#PV7B7;gEWvJO6)>@fsdMFCDmXO0JjKY)z z@;h_s{?gEk$bH@E_hfg%({MeHzQHdAXhJ6B)sH;1NGw2G9xMM#PO^EgqwF(;(*r*okMo138=Z*F1F(gR zOrzo`wBbJYU+ZY>qgV5yp7S@?*=J~xhMPOmFn^FhigS;3BogrAWY_Z-)e3&H21j=ZxapY7_RYE_rSe1`5m68np}@9RvNHl zPa59wYy0^5sUA%RRmru^jJe$0bN;)DzN>X=nNQy9K0Q)<+MSSlqmN7AbY}Fdbi{z^ zPBMsr4$rUW9N1xO!a*d@L z#I+%tc81S;1L^jkMz)|QvpUnr8EnahEi*~d$qrs36Bog`+EY6fUj6Tp2kU-Z%vPvn zS9{huIws2jzZ2p%VU+m3X{XiGyd!lJl9p`%We1 zMup=7S(K39bljSeO9|9q{&Di)?U{X`&cw+5%);qT&lc}r|G6U9l2IARfa@OA!TTZj?F~k*9PmsO8 z?@E6#>kIZuoaBAJZ^v+?yd*1Q8;-R}8qOVQab%MgwN}#MRFCYSg3RSh<`#_0=4-Q2 z$m7)MN*10Rr-P7eTsup;5RcO-Lc6v4<>eIK?Dhr$QGEt!=`+0@gs&Dw7D#%zi<1zA7cs(JH(W}2k ziv5zMR}yo=xo_yf*@%=UWHCCqpjrtXS8H8S)RJp|A2<9v!4=j%WGX#aH<>~&a_w-K zbymXRY&fcTYM{&FpCCGl`>T;}qD2>XEp#23t-6`#CpQyg1L^(xhyI4PSr{^g+0tZo zzH?SPZJ5H#_L~vH-1R0>wNcv&sb^c2(SFILrj}!7q%j!UuOD2t?fleoRr19ATmv} znK^qS6K8gj`5e#8a{9;4_ELEHI-7XCxTNsf??m2-@2B8FYw7aVMLg{~O5%+U(jv-P z?9RH0?NkMt&#I6X%}p?Dd=(T<zC0Fy?XfLNl+mAj19yaH^WRegFm*B4EKhRyE27chCfAA+(dZq;eC1yTB>ynLf#(;@G z)6n)l=k%-!puJD8Zy8;_e;05zgU`d`+~lL9vp7t2l$u_4%vN@giMO2P4Ee3*WcQ&su#ZpsKEW1AvdsKnYPYlAXM!YAMl5hMFh+Ew_1E$`C69v&2%=h)|RupFO zPorQ1)Z^1oxtf{N4r#E`8eqe(b*jU;z$0A4p6BDff!_5^1;}2@Jnkl(-<#qhS&1Fw zkDa#S5#%B|o3_#?P=Q3=qc1J3kX0`fDB{}DDnWr|#eT5#3BairoNwz90Q(SsY$y!i zTnV!YzeZzv5%0?vqv>{!MrV*WzhD42#kl_1KqpHYbbMx7nViNvwK59GD zWf`827_RfaKcudyQ=g)n{^S4o4yQAUoISsCstap6na~@|q z($mwB+LIaG4f(9JjvmBcoYVB6>+^LU#>D3%(%n@Y?8)ZFwv)@%U70`PE`7hah=S{A z=nMt?8=D}sohgQ~-eu8Pfh3(j;wA-RK4&OQ&iW(tSrE=1@W+_G-0zTQY*Z43y%YAJ z!Sra9HQR#=;|$2MO2ZJY>z#X~p({U2ZMn|RPRhg8-~!aH#d=7;d^9+bkINPGGaXgQ z;Y^jN`l-aUNwPGmsutr8y7s!W2HndUjV|$7!GsR?0WQeY(fzlAJpKyu5!G7DGCxOVX#bSRb?y-O5ctyj_q zOO`q?Sm9OUF|Yae3NPy`8oA@7l|d;dq~D0+lHzkhs*^c?_SOlt+?|<4PTxGeh;}({ zSRFu5{dgsmF`SjMQ=;`ku4R1gsO!LcbVn`XHquucph5i!8tmJsLHcqH;_op3<}m$w z(VPv~lLaP>U&&L+Z>nJ zCu&h$qZ@LJD`tIj;U162CzrgXtt58wRg|=TZ zGs`sy9>STZ4I12w&%}DJTUYqL3ZJm2Ixma$$80o>Pw>?9tN{5xPDMUc17ubeGJ)^=e53$8r=8LVzC8h)%fi5 z*ee?aVSHYy$imjytf?Q&#OnPDubLwiUYU(dyu!Q`UT4e|UTYUByoNa^NzJ+%Y0a6E z&h}dAk*pDic)C8}3X2`CcwNf{IvZC^h;>2EAy?cICE`Yfaqct>^ZSQmR=>z&c_h}eUK=z)`bL01BktxfB^{)){Yr!lg`i{?$cW@s|N6QMX z@d4y4IZyF_pTqv#)k>C}DUv^G_+WH)1bPh9V?q=;nnzZ09D$y;NR5 zC#U8biT=fUd<>-jvA=~Bg#DCj6}~W~FYLEI6$7s4;@V1UDS22VZhSw-yvXH!rJu_$ zA1y{(OZwUp3A*EraYyL6W8Es`S1wdb&87U!Pw7$Njls*9m%UYw*9y+L2ARpU?ZvXm zYy|#l9*I7KSleYS$j_0v$yZC|)*^4XHjTorJ9B!D@paZ~7d^iD;^ z&^&D3VJ;S{%Vg(eALPBDH*kL{V#8UR8q!GG`&LL@8z0o1$-4Pja%7X3Yuw&aPR}oq z1_Qj&fWOz?7JAGcNMGSS_9#{r%e8gP&rOQJ#?|DocpSo4w2-1*mC`iA2kkr4cUD)A z;@!E}J<3*eFH7X*zuu_%kn_*Kng8oWFJwS-Y5J@}-YsD6OtnbPSnClzHxG-NT1qE! zb2T%WYaC6^t0TRB4tbo9x003f%4FS0UwocRKJJ(vQ%^AmIn`Vq7L>@C3EuE2jldFD z=IUnWB4|}p`8l#gmL2p%Ok2)ef7Zj}O%9#HP38WON{Q$B{kDpE;x_dCz01XdxK>i1 z4*Eo$FZQ3OBe)i8^W>Noezg!6@_O5+`@m;IBwU~H_nk;Dz?T-H_~(Z_{pN$AX%SF1 z(c@n8T%6n6TxJ#(OX3J}tc4Mn=|z9vw_MyN|5!=R%MeRG^jRcAtLkAWWnOj^`%G!2 zV!MFey2g=+Fw-N9JYa#3h5T7mB&h?K7aYfYbJjK^ALsJeS;{^smawLNI9i+Q^)6;I zwP$Yf`bIM1Mxpe(=8FqAIqywAYfRT%==(L2&+W<8n$ZX6#=LKGWbuFJq3iO7VrO3> zM?d=F%eDwy{h~v&wagQ5M33ZbW^u*%pdWK`*EG=MYb-h0dUo=qaiO@H`e56H2z=tt z4X?s^vj|%m+oVX$#Se3y?nVGP(8pu*5PGS(40QM{W3G%q@h;{I*Ga{PCV4n8ys3o-3u)S@ zM7n$M^Z6)(b2#Le`;re0vyxZC3gzGdA5_^LNxwdQo%_k{4z`r~yGvytKUZ}}N8(Lk zDke_PMbQFViOVmM56p?a6&Zn$IjQg-$U3g7x$L0R;JJaHpH5L|!dmh1j2yh5%g=vl ziS!=oi>W-G!>j4Bu}&_ZY0Tt^RjCB6;rkgIflCHGa*y-t))wM+xLmdc_;9v3g1Ir| zDBtt`;9w2kc&3Q50!rKvdQSy|1yG2D^LhTqW%; z7_ftqnE~u(hOj#**IZk|U6YP;?f1OSIe)8E_xs}SWuu&qOka#~5Ku~eQm_o6E^3^&aTXhF``Wxj)Ss#_%echl4QJPfmr8}Xuk9&$UF z%eAp(@*>6yiRR>IXQwdNg`UKbEu`9o3UR%}{I)h4yx^K`g%vr$JMAUoL$O?b>w$wG zH8@@`6;3B}F|t}~=28?(o7tXl4-Uud)+reI7abUm&E;owvCI%JOgJBo-dl{=%(ErC z95V@-Stx^&ys+T!FuXWrM6Y&vsA}6r)@>=3(O*1q$UY1WLXC)dk&DUXE_3de%eLuW zbb|9ff0u%o?tJdvw3XjJ7R!`V9=LcboLOi_Jj%*Nhl&=Gm{=;q%{?%Z+@cMy{{ZiY z(B^F<(yL7Vtm}z&&f%D{+lZ3Axy-0(E1#ErmvN6gFeWn$_c^ZGt<6P5*Vb}jN{JlW zItu&$*#n87*Y*BqL{DuY^{4PTwerDOJ{O<5reKFhE*5-=5j*mOO)mz(W}6mnfF1TN6WoH8|1VJ#I#!EvnG+>q0g@L(_v|5VF%Y= zt1&E_dCDs?(V2ZLf7XkU>I3cZ+p7TB-_hbPn=G7~UWLtFj>*@vc37RV8mF#nk@<iXY#U2|qAUG|taThB zuUCI|w45Agi=t7hVK_!_oo^Og-KyZa^O$USXoq>_L1@rkhej8eqq?LL2#l7SA8p73 zkmH-6MPy+Hid`yk{zHs(K5L7k{^W6<#^Yg4`Y7MiA9tKN-J2b-=w<-x4)NGsoQbXc zys=)i7;n*!wj%)Az2uC@IiB^a#GyGy<)N(u`d0=*-%W>^%UBPl8(OoPp23dv)6ELR zByvxiLNYPsXBGaLA1xV0c33{1*-5clx;ZlOY#sfE;Zd?|qAfno4u(&CEn2rGr{+j* zj{NCw!M3c2kb~Pzk0Ck7fmg_xu8x*~TXq<38Gx8BT0A&Qe#$^Db#|<{=#+Tt5`^dl z^f126!1<_3jPZ&U9AZxHupo@{X2wPoc{g%Qixx#oO?oyH?*^kwo)-JJWnvP2bDsL6 zvW>aGQ|Zt;K|XOg8HldaDsgXRlq}cV;Y+(f)SRV71HPY+<0`RY&{6rwJl~$oL2hUr z4~wz%?tLbg_w1O|9-yRWl^#RBPJ_YZ@{aIza*s)Z-WJ>51fnV5pFj}`>s%~Rh0{Js1^KD7P2XmKI; zS6UW`vd;8c*2%<$R;%)l~>O5hL!cZP1B7?@_+aD(N6EGMbkv!U zBc96lQ}~?T=KViCM(*(a%)b)|%L*-7XWkFBs<3?-`Ntae80XI3svbIi{|xdD{JHMO z$>tvp$XywP#S?iy&t%R!@5A+)8b;X$zLtq^aFOf*7z{k zaP&Y2V}z={F{Yu$khkHGq49=ch8g#JxSc(gZ5Xw|%D61CJb8fawdCX09o*h^?c4il z;10vcWp51HqjL?b|Nhv3*Nz#HIM;F$F1~%5p z)Jna8S%vQ=>*PpDjM&eLllHe_#l2smJRjspcN+UllUYNzP@>d>EaPH2ba{mDv|eC38lXyK0R{894qDj^gQOoJK+9ix^f$^U-hX20!K3k#GN&a93`A=m54j% zKp(CWmc5kN-xm;uakg|JV%&A&Tvq-1Pt?J2H<=>n(fu0 z`DGoBB=USAi{qmu{XOgTn0Hl+_j7fuMJJ&9V`fO-*Fpc5=hSJ;vR+5;P6K`fl4~5V z#nRz=<|5MlJX43a)0k5o$FpnJ!TfERJH3Za#WZ?yo@e2BNEW7j$->Jcbh>WL!mC5s zxJNc|Pj(jjII~ecgJ(VSvk)7^b8K}sV%p~50_%A3lj;85orTK^X3{s$LP_%+_DE-8 z(Df{A`7H~7kK|Z?l=)DxJhNu~W|wys5;>lCo=NZHiEKC5riFYwZXsJ()9w?cl!g zWTTs%v|?YCO;a2BKG8~EwzZNPMJl;xZ6}L&*vR3Xw({(Tqcl2YDYehpOJZ*a8R<;7 zPoz?^gRSLyoQ-@P<}69CI>^=`72>Zk!L#f#i5_1j4i^>3xvOBN4QsONOi;Cx4!Bfu zhj%Na`8NgZyD6~nuL@Dqz4-gu3VBBN+!nJ+xv;xjX8S9!1150kP0q282^L>b;AjVO zS~XaocQ2FK+>e-#E0?~*d4{^LQu@xQl&)#zqUu#8C7zWMf0F0)K0dJRPrfk23)=c# z7?|RXIdkaxIpm8Cbm-qL;J)-M`|nTr;L8+dDkl5jsJS;TW->qb3|T6&Rz-WgQMS+< zH80b>_=vd#JDF3>f4{ihhb)8-^8fZi>l!>0xaN)fbG*@JEWM4tm_;4ToU0w)$Q$g1 zN#{J#lr{R~6b>FrND#4@Uzxa#sU+e&a}2&rIfUoJvKnL#fO$N?|q{8N^EFHzlXyuSuy`%0H7- zY1p%ceB(m;bB3nkg?kD%7jtjCFBM<-F=#q-6nm$lU@pCJ+@l`i>ja-o#q-U~o*tiy z4Ru-L-s6Eo~;R@^QX(>1aer^E2Peb;U&d zn8#kAeE3=AWA6Dpk)YCJi}F}>+$ z9FvdAeRM!NILYLpwz6WnQryfer1uCLsjOxvE3P<7?^6!+Jl&7F%-xnb7D`FcS<8;P-q5=ao{>z!VRy6d1R*N;JWh(qneHM4Ff&ty8&tZ$geZfbIx##gAK+$^q=mq%ix$r`tG7k)FDXD(-lrv!f51xA8`ghx9WtBj?*=auLbia5}?hwVp51 z$NS+t|E})k32Xk_zO~-;8u7LGOgxSc$Ldw#sNPfqn~UKXGm5-nOAXQ=Fhlw%&!Q^G z_XdO`{SQ79jhWFEz-RBX2G>{9J9d-#?#>#t`oOQNsljgQ_P)-WQ#HB*ZbIex`Y53+x=45dyE?!|j`pFb{ z%}&L%pfuDl(A}8An%RCbz~A^>c1nZgN`8;X6y&(2VsRaEkG5&3{*-^enu=dM*V>lN zj3L(2_8nq9urA#$yYtXT%M23U>l+Mtm_0S0H4UD>eaXiQV;)j+SPwmrkA-wLmLH|l ztWN=sexi@+FrS~VbfWT{cUy~m1n@b!w3%L0U$Pw!*;Cqv+|oaJ*m@x!%lO)QKC4!I zHc$Ux?)$_7T;9*`-5?KrXOer|@VoJbwrO&gGj|Mo53My^jPGb{1BG!ISU@`X86l6uKdMYo*9XE3b~ypEyd1Z1(Jp*K>_`Nr}k1 zj(A#6iQ6^~P#4?dG}m|Ct}0=sP$6On`&+g;;sV!pu5;{>HPaqBbsSOZ!ffgN|G5?& zkZ0upH##b=M=G%~+a5`A>}#Q`f4ivz23V1qoJW3fl@j3pTTs^ln^kT>kkv(4$jNV>q>t_5^zbq}E*KLnT72SZsi2=-hP zn);JZnG=lr+8}H{!p~I&GxH$?&7DI~$aQ3khe3$HM|ZbVFbWi8A~*4MdjHo;8;q~L z0&(CP-HsLPZR2YslfU^iI03HfbT~a-M<<*Xp}~4gb7#*>^#nAv(lc{Fk4IJs2^`Bf9fGa^q8E;ui@WqE$KKZWB+SLCJM=p3~;Aw@lY22?3#^avMetA z__;j`fApfm>}fUzbG>)(4*OJoWx}#8nMHHJbf^H;lkMj++ZVF>iXW2IIy@piK+1f=klqV^70#jyq>}rNP%DjpqVi z5ZkW+`3DN%IFyd7reEMuo%x;P9A$v(@6zd4M>(PDBy&33i^ICkGV>(+VA`2tJvk87 z(rWM=SSjv}nTfs37YdI1cVn4b9N-I|XkWa0<&B}s*_Xld{Am*+ux^J2V;v)*;<{;3 zRvH>{{OtCX=RlquKhLG&!W6DSoW8(+M?O|uEI@6}`7z(}F^){g&@?+)@J%V9>pIH( zx^}X8kdyd3c9L6j6>wcn&(;J5e(4qTW}D!ujR`v0`Jw+CU(~ARk5^lm)w#q6u4Luh zi#2GogpO=O1pM9Tw(7)dyAc7$X{o5WDveorX>i?`hHUZ}TgY4<=v9Dj_Y2TycL9E- zp! z1NH!X@kWRJez;0+<(((=8@u^nL?f;ZlOv$^j6f0R#w@ax{+zpf_b`jHZ#sfGkMtrt zQ-f=}|9HK@ngZ6c3h?@DK59?*Ew0zNt5Kz~OJRXBkK z4lLq$8~r8(y~0BAYF{XF-iDxaY6#kELf|#)KgTS`seL;5AEZkvDuMnI=G~C{ij-`$ z*vj$5F&mdwaEwUIK@GZ*zRgjn9d?k7Tf(z+9~1SqN`<-9mBuVJLpGZ@Jl3)}}6U+?&Jw z@L$|>=abvZB|})GgLh0e{Fdfm5pyyJTxG8EF!CT_JkKYe;_y(R?nUmQs+~ezm;7LT z@&(@Cbdo@q@&3L^a^_T`bf3$tie5>Q-qwlh7bVsoV2mR0?{9htKJ3=v?qNNik-xCJp+{Q_J-(%qw=8Gg!4&eHADE|1_Tq34zE65) zh?2Kxc0-{~-b}Xgu0riQQK4Q^%|u;SeM084ub^LiqRgk4F?MpIl$vQJZXsRAACzeP z(h&_gKjzO+p~W;M_OjOT>P9e9hq690C zSTdG#(Mml&xFuj_{{%E3i+cYqb79D$e2&gRKsb5$C(MjkNG9ZT7H(QIf4jYjI<}RG zdebC@+HMA~XBF$lc4T3@>10}$Byn_$muenlW;UFVX+4!FzUu^Sx)Ot&l+ZO-;m$%Q z6n$sCH75k)SjRccI?$LjO`8Nbd%UCw)X*&&5`8NFoLn>x$6vM$nQxUD>HM^^5jqvRjy zDrTn?_<2i#cYl~5irm4W=_at(m|`yX-WU4%u^voc`~qKSmiwanFkjqR6hS5{0`X_a zFZYN9xR-v~BLXhp$tq{Emneznthdq-M)pfJHkEu*KEAU*&T=_@h^NTyWpMr4f#c66 zC%HDLlN^e&lpO96-bOVSX4e zlf9CCy|DGOF9xt5YRK*gSa?NX#!Ud&)@eBU@&6k)0f$&poRWi_az~ z8(JmPH!E;{58tb7=3cMzVQ!ZnKHu>{=1D*7S8?x^!u`|62%LKqf$f(xIQ5o$9FEVy zVPqFMe{JN)&%aW!m2>Hpt?3v(kZwlq2YNadpcVTRz7EfaYk598u2#z8!Ol`TyR%H| z>m=`6bYWe|S^74tls5M&MPoysCi^Dd@*`t@m1KL<1%00T#$$f?hn(kKMvwL%1kI83$zzh19Iadri z$3CoA?5S#EFMEoWa_OFvRO9}A1bcl)?6Hv`&RrwcD)1($LeiI;pm>o9F1wO%bn?gQ zC%)M7yB|J|rT2J+FNW^(#b*uoby2*QBC@APBQT>auWupiIP1Ajo0W!bozu|wDCaS< z`E~8mU|yGdr;`QDs9+6a0oh9Km#)WTRV z$m7p6!Czfj|0-7CV@DGVol2gOuI%{^%nB*zUYPxRPO~|m?TNra?rY;7lYuQ~ZRmvt z1>GYsc5)g9eqin83VTiW(x=JyO3693q&waFl?6ziQh>panQ8Ha{Uxk{SJ@uNTyV*F#RuTthzYyh8nJq=|Y*_2V*fO1wBt(8;+YC*|VClQJ_! zFK2#tf*swAix#ntzmUCW(^;E8titd6LQwO42&VCxBKp!@dpZP>3i5+XIUWz7@7~+6QHf}L{n%;6Q>qi%19JzeX4?pRz{40Q-W6l$WobOXO*AHNS z+}O8z*~Pu*Lb8?{oKMKHLkW^(q|diEy$9@@XwYAYjCV>jHC3TjL*^p!{aCOp1hzJz z==OuYeD2$xfG)-eG?bm9I?p7iRw;&B5GdbT5<9-K^tYuL1M0TV`YP7=?N+@15(M$Lz_%UaoDT zuFiY<|L}~XyIY8@vPfdDcwu?1a6GI}_xB#=$n-ap$m50bJ3V46U$aKF!idV|xp89c6QO-Q#_Ib#5F_T)03&mlaC!&{yBYF;bA1CrDm1fdlXNk0b!rFBs z=EMHRoYO9O@Ne2drZ6YE3w>wDis)yIWlnA)`@Gk;mBTd(<)xK7UCHEqcBkOT**vsa z)lBBnFZSmkPo#7U!^$T{T;7p~PrEwExe2B6gRfIQo*W{1%yzSLq4>SEnA9wh(OXyx zw+_QK)}dBz&Sx*JjT|Z|mGsu0=#UYP=ls6STd+^|a9jCzWRbkS>kiA4VMw{1f~I%K z10FEv*;=XW3G||~I2_v?Qqf{&F3Ooh9aF24x$3ODE5f1fmV#Q|tm$U9mB&11_?+R1 z7hA&6m0ra-b8?+0Y-Hz%5-C6C0WCSlS<8&5bu<@~6>X%>#Ug3<$rD9U;duLvJenDE zLi(7?zy9POk9cBKGYv`$jkt1|ee@>QGB~S5w)dy6Ffa^L|46}$i_E7!)j>vwmC9*y zZ3$8I04^}%W-9rnVeRG1y;6xj;fYsWI9F{Xm-mL8-RHJa@~lKcZ+f5=`M9D9MzkE4 zi(SkSeppf_XaDlTd0uDwz*H25u#VlSos=1V$+F$-^G;-LFMqC*KXXyT#ZrciES2Zv zK$Y~?wV{WxF8hX!JuF2PUqnYdGo&^#FZhuW1Hb3OGq$x%EG-hxL)@S4B;QKTaZ=f5 zoJ+Bi%MX};O%7|ST{!C8Frdd+UJp6hG`k83c}ni`MHnvRlfxoMIl7~zZ0N?d!vrrF z$jOHA{jvV^85+A5^pus$pxIt{a4-zkt5RUi_tT}E_w(Hn>DI*qPF@3S!olmat$+|qObZ#eZZ+SmBk(=Z1{hN6TEO_2ga?)I;%_@_%tJ&Xime+5` z=U1DHpeOBQUrvb_mU$v#CEXPo^1o61{~v6ndv1wbY3zYSa&STQQ*b;Yk6tZ$1GVMS ztSh;>A7RKLC;R>ZJ%BAc$b_cl@}tCq4vjFhv^8P?*OAxR6Zm>SsqA(4z@=Dni`!Dr ztOdF0FYToBgJS8~g!$br;qbFGqM0xKl@rWF-?KHhJT zEWPRlO%3`qc9G}h_Z{%Cjo2iY%8OoJxW;kjVO!>m&(346i>35-E|Gh`=s)GSVT?DT zoLu36*H)6OB4@YR106?)V=BF$(TY5@7}Qn{q?gIkV;ryeTx^Im;5R-;E$rHg?PhtY{~fmzIe&$GvqE$TKDz@#j?L5Pc*s*`i3Y zR(WG1&(*$NHsIv0JUU6*$;hGPb6fM=gPdl(ixI}%^i-BxNQZ8fQf-?jc9I)iy@-Cv zm$_)!tfh=otg?j4Q=wdnoy%tcL}{T}i9CEt&G;O@~d)IDcJ)TPgOd9HILER3@scyGvQ*YP2^!tGvC?9+JvROdgg1GdKID=bOs>MdW-+p4 zqaB7!41^PToE~AUsro9^frDeD`(is--wQ?44w36=Rg?XMW%202 z+VZLmm1sl`v2d&d`|ShpJ~$o|Lo(5i{T7!G#>rF@J36aYqc#0;zrJO_X<8L-XC0I2 zW9%@{KLCzL z+F|G6Kx`#1Hu3jN))lJYyf0d&40k|WVIXR6(!psn`6>P$3;8-4l|3pN217MW3wu>2 z!tKbP#zsr4*37C}NnUlD79Q_1uu7^}4~><)W=fpe&m3f9Jaiv2&^VaAoAkIfBj5U! zez(-Oyq_Jjm|el2*EddL>)W9#f8NF);_*X64Pqw7B+H2Kvoq zzV_lMQ6ICz^TGgJA5X4!Vg?p#D$)K|jO=@Dix=uZ42a`>sLDdUnN?8tix^gy|a)-zut)c z$K~)Z8+;xfi21+b;iJt&M{=4Dbz@{zb2}`UOrK_YJYBEMzb>XOYs z(toBcWKs~m7`2!~&uOn(^gjkfOU^-ixYi1ULufp1X)~bMTZJh@VkLp&+miG^6muLK zS&h#-`QoSd{yP`6LCg0+Q0H@;?460S$_fm77$udR?2wqX8hv=3kE%E>@p;U$i;-5P zb{M*YnYlgb{XCh0LUN;R_H#TGdj#-(i}a#*V?qYa>qTi^rO?w)|XyLdSf3r+M!)1 zdT*C#vA23A1|6=#zkkI^mmTDJvjX5#iyjYpa-XlM!t>s7;(g2>^)@jdoc!Qgjx(EC zN6dN@ClkHxVP6@5iq7Q0&(q6xs)~*-a;!#M^d3sT=O}WZ(=u`I0N>A!u`+VMEt>Lr zCV%2{u|E^-8df18EJpl8>@boX4yFt%LX(CD?x)2*pvM`P@v?S_o@ zwT$DvUM8EFM;huMS?6YIJYi@w+tuy#q)x7d2koys3q5BDe(i5?JiOG9-?)a`_gAHc z$U5H)^INwxSZr%-T&G)WsOa&*2&`6bmY*lqdXcdArjLEx)oM1U%GPEaVcc( z_r2ROa&xOr9F|HjGZ zJI7_!isN!XwBlD7FZDxX#rN%TS!$(~6LWMjC@oe>EO`drf*zh26&`+Yz)03Xn$1z- zUmtpKk~`w^6te9_^a8McbI(NukAGCm$WM?y0>v4auevzh!{dFBK|C5Caob&$thk5Tj zPk!gdnw&ZtfAjppbV?QuCuMOQ%EFmVbPe$Qz`t4!>b1y1tK0myD_Pja^Nr?4_I2)N zE$vDszAVq?zh`4*0lf*V>nnIZ9de%hVjMZgx~!3qeKgGE*;PCC?T*Vr!B>8sXXb%E z^#5?~YPGt(7;ZaB`h6u9!aQli$I zAg5G;^+Bwycc_%7zndVAxwmaTSI8y5axz|(QX{xRCM>8DllUrWvbtP`gwqqht3njt z%VgjmRrK~(NQoQI-RCH9{Vg-BPn1cO8SB1d6=VS_#W1;2+B4_c&a+(pY+Wfbu!!g~AqT6DY|^ntaLA6(DT?Rd@)6Kne-u{!JTTYQi@+#5BxS7|@V zAB(nlqwg0VuGjq#(TCpoS);K*5y4Dn4JvSIPU4zjI4F+{2 z@A#0lpRpP=U8cd1U94A?(78xnu?Ej#K65|#4?o|%kSqb~`{$J!EOjNX<*Pw&@{bi~ zc?J=rfs1tnj@m___W=6lcJOt!vF<)Bf?1&&d~C^l-S!b!(2-nKhg9V5NJZaXJkQ>h ziq~CJF)l6@o$^yK;XXO2*D3h2iTz?^AD6kN;YkHEOnytlgjMtlS*9Q{lV=?fny zJ%#7U`M|3@Y_iLT^}Bp{4PsWbZ2{{3l@ArqCD!+4?Wq_21|#TK;yH?4Rz7|omxn3j zr{;Ad#~4ShaY8^Xz;Sy=DGozdRh~estRm@>sj+ z{o&t3GV(BDGqc1R(c{S1vEqL6a;Qp1PP3NjgRR7kz07l`*orr~!s9*3GHz4KzIS}4 zKHACc6=Wbb*ocf*$*IXIajfqo4_;VG8u^IdPrArOCmVS<*j7U3wUhacY^7FDM|o(c zlG7jTrE6PDsZSqN+Av#bIk%nc$Y?K5W-6u6C|mXeI!OIQE1B9^DW~aa?6s^y0^TUl zcRrtsDHUS!vPv!`C=lDl1XD(t;#%t}c{aXEY%W*Go;u~S)`nS~-z#L}=t>FW=a;Ri z2E)xNX=70-m#0>U-l{^{^;2N8wnCoj%4H<~Z|4bBGM1mu{81uJ>3MwnSb;E4G9{%Z z@ZrDzeXUZC^Yeddcn-9Xyzf;X_!)gM>W4R0^87I5Fmv5LF?Yk3XNVWbAM&|rtY*IZ z3LiYE@J5=m7gq3WsL4?ublBhyL#Q`<)tI}HNx$L-AG9g)LB?SE8(*^)(2Lok8;;`%;mpF&z+=A#Te!Dx2n~)-p}XpqhI=bMR}m2idc~}1K3fVtqZV-* zdLdbpJ4ycHGiw3b2n^3+^`GXIUwSbaXn z$NJ`B&%u2Bm70$?ANgEo=3(x_JX|s4GIxuaa3Ag%cADE5x_7%~*tj^+psser(A4^s zYlz7xH{JC{$t`kECAaf$V%%P|J$b=<-%3+3T<>^I2R}WbC?%aKVG`U$4j4!S~+<$R?g3e7hgx6$Z?$*cPU{pMulpY zO3Zv`kIA!Dm_t6MU_KcOXBEaRwMR&aJsu3=+A&m#TVYBZPgY`*nF_tr`LzeRHay_K zQ!5ANmn&gg!TeLc&cfYFm?!Y_%b8F1Mv1Zs4sg^fvCKk+Bxfh=`BRCn?RZAVui5g! z9<|;pG3S*MiF-rQpXhv z%6~KRtdwifo5zB2k>_7N*XZru#P9n(6uXT&Y~^}wL}&7a;X3@>^cA67Vxehpc^M z9J{c#P)~=tdvw@M_Hf%V9cJ%gX6Zoouej)NErva!m)X1WMhlDA39!=Zm{+fZU6>v> zuhQRGhk4Vv+_z=u@wbg0kKgLpyTf(hb7qy;>9M#=0v7SC>%=)7(#euE=$3_kt>|UU z&%(@kWDwo5kb08q!@+dYG@+}JfB*MlHYWDUf*skL{O|N+)g~L%Iva15%!vM!N#`tC zlSJl9A0eBg=Q(f>x)~>AF?I*a2B7uoj2M!M88!Se&;(mAJ$%rnKj9o6V} zrss-h=80FyjIZ@WlSw|fPp&cdj4$*v=(2mDL5tdCyW2&w7c~M?CvmLfm~={;ik=JU zwXm=;t{$_4&FHrx6W5q$`eXJMpm~o1981f`&w0$p z^x$0VZX+I1f2C5s#Z*b=#!9hSUnR*~6v+KbADFEP_HFRP_XU2iIZW?& z3qMpw`6BBCGnUE7*piDodo}`{awCv&GZJ;Caot6hU|S2i8M9MiHa;CoI7T-wP9-m1 zfYtwU+~xc7?q?qAZZ4oFr~p4Fbd=AH*>mKml8OQs(OIjc#`#Wix`1x0am<*0R3`Sv zO%c`B1Y--UWKdtSC`Xu~Oa|k!${(2LhmtWqu;84vKaA_hDa=wXqBEG>LySb=X1`Pn zu1)@fbA%P=pB|p+7}AHoJH8hYPsn?&&c_EW9apCdaB3ZUOYU@*4?msd>0)PbYt~UB z>d?D&xT6fYX^Qim6gYCJQiRu5AI#+Dy)^Z*F9z!U@zT-{8s@6jEcHd9qaPX^qJQjO z1ap@o&^{*;i_b)0YwZYZ_{I6Eklt_GRJhelL!BR~m={HVaj!49bcbs{MFC9a79ib; z@6GW7`h2>`RPHy{=Q&HGab0Ba*iI69qlc`!!?jSF0|<7XNUEud%gb}H(9 zOv3=LbU3OCa6h2{zunKrfGcD{crO)h%g6I@tpxw0m$GV!Vis~r!ke9xh;H$+>ZuA( z|5c&yLr2s*paQI&@#PouolEG}^9{u}?v;CbhoVIpeY46?Jl??beDeeh?3xIxa*k6T zdVHVA++dC${R6WxBq|#nreq_nCK(L!aqY=|wWNPAaK1vlnQVyX8HKtt9aFp8CCISg z1nJ?Vl^Tv(@oJbPvs#kb``ZzdBIvj3>WC?>DxCl12*&{`EO-_Qmu{g@#?kXv6^d4u zLg9Wo6s!9rpnOUKj=g0*0r$bC921{4;A}EE8&N#Z|CEpo|3Nu)#b;v`d6g4WnT@$X zp=E9WP`VHo|D>t2!L?*8OBHG@na2BC`WYim%Hlthm}Gh5wpR7(Rqz8*2w|caW)?jE9otp0wkkTa)Wn0M0R7=29Nx-*CJPS3{Z+-!WSlf!4t zM4e8Kh`9-B#T$jXCtXrW-A&X3Iws2TQu38_Q$L!TB!M$d$@Ad}vizbF#($jPTi+Qa zd~a-5F;A5Kua50QaXKOt9!<#hI1$d!Q|4q)xkN5W}vMRy)-(`rslk6^VmVw)q z^5<+DNj7(qvRkEc<7bsjbXU;xZi;d{6IhN>z`c(j{?z&4+G&5(X+v)<$Llj3hhFm; zzj#K2%-a#nE8{x;WCW%(iNFm@KI>!nj0dIT@3CYVyK!u^PeRRPmo^x#)kNp57N{CeVt zoG@Sf+tm+26aVux`l0Vw^4^#D{pUrXJNFuWIFHq~j>Lkz2o!Ef!<~RM=1j1!@MbDJ zho)f{-N(Pp$isqg_76p~N8lmZZd0;p?gi-c+)=g$sAS0Dtm+Ry;Go zT2p%V8!9mSyaGw@$)1lgVXqm-F;BTA_mDHXSILzZ3Y==i@p-%{2AP@QV_waA{kB;`Igi z^pe*SSb)i;%nP4cfTRyD;uG0X`hV}tYjP2@EzXkFx|4W+F+o1}&Gwf}aDRje>|U85 zb1u2Yi@vxx#E))OALujKOL5y5Z@Cr<3}EeMas--^8Jw+VUU`Q|6zpLJ^@((Bx|fR0 zWKSb_?_?ZFgL}txJetXQ;w7EFKiFs4J0BYt6`-P70W$w)e`2zYtY!xHqI{KnrPk&5z^QV8D4rp?*4vYO!Jf2zDha)g&X#`pY zl82qZJdc&^UEuzAm}5HnbIs$JkcJMA$-_paq4Wat%75}b*;T+ELiU!F6=3^~0yN5OSbIBS*(@ha^>ae^autR)Tm$EaAk|IQbzagr0UPfAS9hg1eJI(qt~uBp&o%I)984UajrqQ;m-fiP zE-Afk}^}tPJ)0n0FHY!0XU+d-8@+2{HjhFT@iE{oH^X}Jjk5jE9 zy&@{CUE+xMZB^Lo6Ux142)1k1;FD)4yf=hmR@YE0dacLP1MH&NfoB}=)V=LFWQ z+4o5hd94-OnpznV>VzrZIiD|7!u_fvs%k4SYY_Kdbwe>QAe85wp{P;7zAle7_`!KB zkK^&Ug9#XPQI8}tmVG%!kJ&`8@9)`|wun7XoX2i{;d*~hHZF7CICfm2#zCI{b6j3A zPoXYvWTKvHZlX4I)5-Um@p7Vp(V@#c z&(1-4tsLC+q)&4K&(6s+jyX+VB**D{oa4_GkwpzjVy`V3)VKuk=+1tQe-p*iBT;M{ zI-)}!9n7b=k9F*s*|3S|X-e0_~w)AR#(__vFdI(s@uTb&# z#C_MmCcL)L9P}y4#`5``*VmH$?4FIWZMbjZyp>6Qu`S;d)ho`Y*A!~kFADWhC%s6| zL@9caDC-gvB|AG&rr4j73FS&0wsmC2gcC+jb0Wj#1p9i9*xNW1gNKBoAd+h^w@~ao z7>YNXSHFHuK8^BV)IJm$SHT2?hk__Ili^5;jC=YQdT}JmctW0ko_KW-%pe~$xK1v*4z`f#ZOWK8?T(^x;W%8Fg6`xc*UUDPC0|RVfPKOD zF42!xYDAAf=E+8xOYd1FqU=DwnA2Cr7)Gn+Z!wjSs-BMc*U7_r>*GjnAvnFn1gD&~M!F9^fEz4X?-r|-w@fA)J&?RS94V~N-7{qmeQpbBPj2y8ju-ab z2}8wFdMXFx(obP7`%jSvWUg`Z9%0xq#ei!`^g<48Bj*~@Ygx^U=WpTI#rJvVe0uR} z(3?5BNLH46B9Z3;F>_hp8^xU8ITq5oCcTy`=_?$mL9Ha_dXuLc5N0Mt_e-Ql8*-gC z;W(X0|Jn`qBj@p4C!$2EC3~=^H4N>9dEW_nNbS{DW|)*o12yw-FNa|+>-CMl=c083 z3z@f?*$M2!@cP6&ZU^#H+qrMOO`l_WrCh&5e_vG?e21ivRby}S5i^kkr7|l6kJ-H3)>dv^4s6vW%OxJ_@#$2dyGCrKXO~O z&7{xupE933@0-`;;K*}r$j(I@V+(mbw^*!n>}iap*Rnwh;?2l2wrMLa=ZeLNu8MYi zUOw((?e%Id&T6fB=2a=1$V>jm1!sIU(gnlci=O$vU5jNs^V8jaqZ5MMq7-~W*}mqo zF}F;{KIeUVJ{;GM8reUX3)74?GR>)6svjmVHi6vkp%i?I;d7)h7cbsd&B8r#lsw?J zKI8${F{hjU%KeAwIVG<*b9ERBd7rCV<>E$7=6X*e-$xH%@&M)(ml(0zoX@+ok!D-V zq*FU@Its&Zva1ogv3a-I&-CS_V5P5j;D(#hS6XnLKJ*A$2x-!m?R73Zuzs zhULP#cS~7Pi@EL0Uw+8@ZTSxaPMGJR%a5k=y;qqu4D!I~1aicmjo3z?MPX7)`Fm=) zOrr1d)JFOfn;S8#VIGohn9H&EWm2P^2fS=FxWk{T)5lzdwdMWUw@f1AJn^fTo?HX# z^P}^zs<6GdA1IU$Px)N9XwcKdh+E#wufNz%+BPVZvss>Sc|u?3^c0*-BcIr*y;#gC zmOPCY>OKua(R^-H|TS%>NP`|?VG=kN4&uCS7$8ai5RJTU7}IQEUE zCwCS3;t(t8$sF@L9oV=96;rL&q zy>(Pu*&DVUsQc8YQ7@W6sSC7yZd&Sw*WKL>3zcc7-ePsZ3Q2&vCqUf|lDZq#c4}CG zeE0mm^}c_6|9-R9tSK~vGbiVqz4x=P=elJl_ZGgBFQ(TlVW=I79|ps=3%Mk6F1t3D z;rRGi*}K{nC+TI&p)c>_MSA@fl7F#{m#%U4_{bdI;+^Du$lpD1H>1+9I9Wu_CG$Wa za{Us~u{Z-ymz3d?DMkk8*de}C5M)Ur*7l)q%TR`-zA@5nu`M%a$a9f5EVIbOf>82G z%i<)gqCG6n1Yy{YL`M$+;BoO~h&LnIHX82HcI2wK4Ya4GSUr znEg*quJOw&X6u&1f=?IkqS4akL@(_30yPH!~COlgeQE zb-#qf+wrx5s2Z7we$z6c@G8TBRnZb+wnu2kK)Cub2lf*AubK+?$K=TJob0f2XfS*d z$O#(B6_O|VMZaFf3#5vd2(`zQH>)sgJ-vtI$o?)dGgmHJ zrjD`4w)6DXDH1U_I1_~j%@{QLuuPyAvW|5iJa|4ol2;nwU5eP~I7uC9k4FJP=*aUK z?3Ic8f6+I0Cq|qX+2eT^a)RaPdFn~-j66{dQ>;XHae$L=09sDbz>S>4w6{TLIm{zoS6J~HExAzB`; zu*JpfAe?6{e==*{M@(k4UVBJB8ggj*K@HjJ_3`e9% z8wbof9srBUe4m{e@HuDZ^DtJNn73QLbQQ+$(vZL6^?#528oAx!wde;-qqni42K}C9 z!tEV%jn5yJIhAZt`Yniki;2h}Kb!p0jK4mT>ntXRyEcS-dE{Q5=pZ1+y5L7N$7DOa ztU&)Jk8^JpxlV60UR{otUZ?0)tjEuV*TeE&?S#kkl&7%!0j)$;nhS%#X!W5x0;c{i&d zytN?*L*CP8hZzZO(P9~557(N3coUk4ts673I+ota({b{L{OKI>n+{i*i#m*X$0=qk z4Nj23o9u9VLJ)8!5$V;K^V^^dQ~2Cio#TMcVFB#zPsGpB8R+9$2Gv`BUgQ}kw^@a@ z;}Y>DjlRM+%qt%dE7R!pTf_ga0k!ELG|~gBs zI#${rbAT=Vq2~h-JT666%gL_ad zekR~pbOuKDGs7d`u#9Wrh}OK1KE)@{UHu4$x|=cM%wgHwn%7SZpEKRa&AHRdx!H^* zk7A{U!WJza1><)!=7F^)pUC&Ael1q!lY8}j8-Vy)NZy`+rlT_Ojk(*0 zuf#~zQafBY$MfmR`~6o2fWvhgZi*cRq(_cm!k5 z2Mu=f^Bq)$JfOr0X4+$W+h9cAN}%hJykQ;s9G&9i;#7M+7Xz`eNg|r|&%}_`sx=RTzsc-)_b3CrC;W; zU4Pl~dXMG_Lkx|tPSiJA_3Gm7k|_PI^f-N5q=VsQtkQ5f@4Y^ER~y6MxAQNqjyb4r zy{?BrQ8>y_$!)T0rq>Sr(0L(l?-!KQuR7I9Khuz}pV{2`VvUir^`rYIx>cF9PH$VU zwf;EkB8OWgG7mIKCQQ-Ez292N4M~vbjz^@;eb#g6Xgu~!E8~Z;AKk2#hX;?4P0`6G z9kT4^4oR|@jIIP}7qnhUnLIwSC?+C;$E@}qgWT}TEh|Twkc6#106f8-PcK0 zV;O7Z#aEdDQC*ED&D40Cug2IFA*}0$u=k0co>T0r>`pHL>qtg#?m_>}zWm2(IKN_V zD)*#QKB+N{H34H4H54D1J=l~^oiXGcr-agxqef0mHLC4q|LQF@R(g<+e5l4Vr%+fd zW36Qj-(#Q}jV5X_BvFgp`5H9Q|L5M}7;>9V#d>sBaGz)5GP+{N=s3S5=eSCX!fP62 z{iZLv0l)sC!7kQB*06q6(o%~tuH5fFNya&pd)U?JF*vD(;tuOv949-o-u0aO5ZNP` zV_la_B>xT6@%Q%DK&|8b_KEM?UW+XD(02H2glVY}wd>P8O`iP9Nh40%nxNXpI#dB2 zIjn6cV!2;EnjGUF^7!0e{?eR#*=yj}B3QU#{pP~btYVrk-B zDvS1;Wh;C8nzS$dUv}-YjU_UP`9JONDlpAcfsy>aTYv%%LG&{2uz)JnET2A>%E$K# ze7{CM($WG?EK6l@7T=c+xy;SXFk)@`XiYkF6c&i|RbX9n<^=_FZ{F1p-i!Ruw$vMy ztNY=_A|K=*WiGDK4?|CSqgJjDru{?j8=0%Om$>iooO_*IyS)0ytlKJn?D_P=>QWzU zYfjh07GFee_Q$_`pYd1y;MHd&8tDAcZHGVVlY3nF$Oq$k`eC%Y55~+G0jsXeaysLS z`074L-NZa6asWLlL}2r=2s~dDfqBCGfWino4Pw@9p9s8Uy`TkaQN`RBA2}xyKXb$J zBP$#uS4UvAdnB&%b#)u_@44@KJ(+w}qez$rkSpM8$B?ZuvbKF^757BwPa648Bv!jJ zuX-zea=*!KJzy4ZN4ghmBT(`$vx+9BVNF3QGOg2auRb$v3(`>AJ{{PS2D?sasNjPKk6+SY?2-n@_v``N z!9D47WFZ5{V0B~G!n0Hayi7yAKFrz8PD73MbUAKH1$L#;mz@Sv{anCsvg2C`tXDja; zhpp7~ZYFmYDrJVEg#;#$vzTuu@4C3iUC&msts}joRTQXN!hQQ0%nuu87T2K)Je#M$ z*ipPs>RZBGM}gI^%H*z1nG8uX%aSn)^xvewxe5xDRW-}Na%HmVCij$*707es`)vFp z#fDOu=0R?e_gwL5=2V|zwzP!>2IVQRbg5Zl+9;5tHjDm*1srQBkZ(~cH>#QC=O@-b z$R3)wPnYo94~Mt=VI=R9CqsPk;jAxCzGPi&sW+ODJ*nmG`#TZ5mIE_qVRUaIG zPY&cXxtSPW+;C!+dw*Z7jP*f-W_}nG#|-x_{s^c&0$&QrM1J(cQnep0{2=pK$sc|N zeo(gbqbJRmpSeHUwerRL>QQhda~QrS0y#?}aFEyexu+3mefqz9hWE(s2wWj2Tu%{+ zT8U&7?~ont%lyj>=1M?30_a%;yq?pH%P-3 z=Tz)ZNu$Fm4U<2R8{&QUAtMbnFQ$<<;-1=%R4gG2@__eT%ok?Hze+{(>Et9`n7ew9 zj#5=FbiAkLAIZfP?;PgN(Zv8n5;zt4K~Kb!9Gc{ODY5PiIO( z4$7tEpdGp5A8*^*;J~o%Z$El%3h5ea}Vupvpt^Cw^{s>*L>Ef3C_aH=VQF z#e)MI8q$ZnbDI%TC4z(kJ{Xy0Gfjsf+R7yBTUdJlB1Su2g@zK`Z@* zsJa(x|uGs z`5YOIwdFK&C6q2kzIJsJoh)dZD92AHN=;+344RW5wr7&$c4C~28l@2}Gp8?HrhC!j zh`4Z``HdM^-v=g$=2?QA8%dvqU6Q!ybmIJ0Cnfxyw>vtbM-_5~tifFNcHlZu2^mdx zk!$efmz8L5PuE461B@d$XRN1W|D+?1PIbcYt&Yg=VTV`M9r1ahBa$mC5qQ%P9y&*6 z=JD%1N4T*6WfotTbb>jSLse+O-kKj}O4tnM*PK6IZb%Bx^*x#~5 zi=pQ<7*LW3mj@b@+|^=cWi7LuHAow+MGohJU8ivG^}7ZYE@{zg8Z+2B>Yy#t;P6fj z^zK>&?Bo7ll9v4wbWELQHd}oy>IZ9Zsu^=NBl$CJO&GGlgbXjv-QF7EP-4VdfBF=c zaNW&)xJqOdOa7sA+m~F@4il>98*!^KSr^t(3@-G2%wc}?6eH3uw;8-@ewgP^KEOBZf-3#O%h7Ba2*4h%CZuw&uT}k(su@_^x zAI8Nni*hVoSEdM9?}&imJDs;4?3b7s3EQrbNKT+rb}_kYKC9lG=QGQV8ODL>m}^f? z?=*V|t}@$x5jnzVy#GJtV*Fr7I!c@*Ylp2YEq0K)+nAME%~_(`TA=kd3zV!P7iVjU zcM)_CJ}ZYw-O1|B^rgeyAJdkRnGf>EdB+jhG?l;KHWE$8(yiA%5>IWT@Sbz28#`h6e=1tasOhGs~86PqRzh~3=_m;WJ7U@{}B^N%Oa&U`$<@~mEIW6P- zryv(C#<|F-qhwEGoFp&1gJjxvl1V+CndxSU#(||W=QsVzF60`GW^wya4!KACFyfvM zc6s|DgY(t9x$MFDn$JU(A2)i_A15g4d0HD_q>^gc8$q|EFlMbnENC= zmXT!~E3eXXRmgnPOU&k+lOo|{+Ditrrr@fTPAih-zntJ92b>T_=4)^#W_CVOqOMAb zI-}Jvlfh`SR*mnKLQ#8SD6BPV42#fWMJ*lHFVN!hEFIR=)S*^o9q#1O`5HjJ;Dr%0 z$fK=4!hQX_%n(jdxPJ>*xa;X3>_aZ326?%ToXyfoH%&6@ z7b-k_>`2Fe5>uL}uzfS@1s}*h)aBa!lp2HL$(55)i8`Rhtz7#5)@bPpNR_hXEzk?i>y;* zfEDv7|4JY)tdaf=Q^auz$G(3ZvGO~|n0n-8PAf5@K!sZEoLCYm=Q{$^G%#>{Ngl0(<0LHx@pIEJ(PGyC@*fo+ zW4_XaiG|E!xI=d4AlLbed2YzdOjxRLzhG_Q-gT9QdzVcL_bbN}$aHJv(dZN@?Uf|| z9z7~klt(4jTZ!mMCF|qN@aX6acsC6dpSyU^7X1#-f|A1j#uH9S%sn{O59kW!WVze9h4lCHwB~o zEj40av-e;d86KXWBjk0?r_)=h*21$;i}k#YcJS*7tsmnkxuyVmwk&R#(2xAgq(kJK zZqm^fpl~lB57PBIxf${*Co5RESG=K=%d^`{xd5efDppF{3T@=XPX`&SvqVTMORlrc zGA>DhJuelw%jfjr^}gt>;Qc<2TsPMyZ+`kCl+Wkz3-s${b3L5PwRNK?JlY?D`@G)+ zL+G!&mX1X)(lBrb`;DyA5&t6{3*Y79_PIPPo|uOyt`VRAlZzwTJe;$1l&xVZSu@s2 zM)hkgo|8Ju3%#>ghyrIV%K=9%;5CFE#JL<>c}(Av{ZOGi-SsU;Ai1eOet%4GN zpTbdr>x{nkkvM*znF%$b=%=M~Z!Q_MLus&%Psd_DtF7Cl?*FSS;rYewsTyWY%R4wyMFZfH!Oz<97B3l zr7tqij~ps9r@4-LINcvlesMk3m$}zXqR=Fo>l#b0aS9`m$FVh`=_Tyu81ZglI?BqW z=i>bFJlr3Zi!M|0(EKv_!7{G%r`wCg zIY)VVuDuv$x=7<~9b`*=XX#vAD%1N|AXY{0GtLqlZd>AHEZ5K6k2hZML+xFDST}@T zL@oRA-uc0X^_r3|5!hWV5*1j>apt%>#gpqqj$Kx3(=oYYI@}%U`V38HLlt{Fo9AKJ zX!<<)xizATdGBKO3*5@XntBe>+t^;xySA4d&K+cauXbW8>nQhPEzqw^IeNa#Qgx0c zb{(_C%_0l*sKL*QYu{Nj{P5Dn54*?vVS6Ea1rA4|71ylmGFa5MsQS1|n#F<6u zcoUP3;~{C-Gc6s<+H$VJYwG19o)LJIW^V|Ba@#({+;vm(H?wWuTwMkk2TeN zvS?)SS0C5Gw+ZiiUoA4%nb=?W7#k*=;QEq#i6_{*Gv0)q298^GE!=mhEZpBPUtWsM zn6}u$-TA3jel1UuAsk1iStrTo@5wUtXOhf+r$Y7xCAObbB6m6cjEkJ$xK7DDpHMu# z5rP~YS^NO@&+~abp3lc)7q#dXNY63HjV>WN%$`l2`Wt)T?-=oUjtN()nXvH(>$$_p z5Ay3VtI1ZLQ@HmhtGAV2y~rKp^XWf+#{HMa4YZ=E#pBXw#jR(OESZ!dtG_$qZJ-io zE4Rh6I2GAmC#;yn@sxG&({0qKd`u0?Cu%5LgyQ@qHTJe8Q#q02Y3(G`nxn;rC@n%m znL!<7!org#6z?&i{V?{gCmNA>pMCD+^Gwz zZbzVx679&rKHQ{2aw8R%_^MESM+mN_ao=NXDBhIPUrAoq$}$x9-)XUrWBj^}TnqNo zVtO+j+!tvvD&jHsVwn$ql%JI&-NMJ%gZ6>7e;;})ds(>u;e4ZL68jeJDcpCgu=u}z z#`&uo%A{$3cZbnVss1PyXRJQD}gQ+}VdK4JCYD zf$Z(#1&`%nIN6_my=vqKCpD7o(SKynXm4~Z4I}%Rim3_Y96jpFwuVLGJ;)QHVm>dq zHdp&>WL2y$6}1I2euNk1k|$byo*dSPY+PcmcU;pyQt7rg=H3fKMN8(r*3QQ5Z}nx$ zi+nM3^F&4${@z~f2Tsez*^~xS$edYKh$me+JF#Lib6Ux1Zf#UYlw%7-G0qb)Kgdh+ z_#4j8#(;N?WZuC-u{gxs>d9f)&f}@@CJWP?>r3lP1yXQ&I9$tzb4^N4%|9F2#f`=9 zYrcGCUh}b!;pjWkz?5yqE*q9V_*6sL%e?P|)}EMOi}lF<%nk3EgH=ncq;7n%M7?E=m3-Ny zs8n(RIoQFR;w6!P#NR|uU*B;2wob*yjX6kP)kr?l8~D)L2SxqEuyY-Ke>ThkpVdlK zx>C8?kQr6vn|e1&MU^($P`+#|8xI!9UuV3KS3*9~U_jL0S(tOFfy^f-c)1sIlOvg< zy}$sQn_1ZV!%8BG@?~g8Z?xh0{I$b?){nDr&7+ZYK2{{T{@#f8A=mlAfXd_(N7ij4 zo#RVI*V_x%FYtKgvd_988`G@Xh~t$asn7i43YEiA%ZfbU66P<>pcijgiNpjCN9Xu( zEVM|azdjpvuGW&0cEvJ;dnzlK8=l^XzRR2}WGLE5rH8*{5zj+~Tj8v?7?6~mjd1RU z9uF^+q;PNi;}(WnuJkJM_)BIrm77`la(uTZtP>-K{wb+m=9|3`Fh2|teN$0H{&Zrw zx)QmvK$`UBeXXS5&?6OJmE>M8)|NfP^X2>iZ{+j}M{~0QI)4AjH2M~Y|B}J4J#p%D z7<@h(aNHvs|MqMkhsV(q>Pb#El-HXo6&dZakwvLkgkx^D=F*B9o1PbIHzMqZcc}?Y%;~yFG-V*`M!|<#w{hr6NVV+!Dreqe&&80rr z5*3c(r3OT_&VtLk`f~YEf!ML{vUX4I2^Q($!28bSNzCd=B_reLDpF_P2I5a*R zW1Ordv-}@9GtGzjN#R&pV8EN=Y#e@QBgP+PQuQ zNv@JS_`_8A?axM!6;@L7^=~nE^gUl3pZ6r-ukrNUEi1$P*3lBz)&WI5f>30g$ee-E+@<(@u z(;qkJu-x5khr0uUaB5m2j%qSk!zqK?%xL*F*A_O*gHW$l0=l(fKF(M2J5}Q44!wBo z5&{v~AOY{cXJGsIGPvA5B#+zLVV*h&iXqGeCKpz+kNLdxl$9~pI3b34!JhOpE@m(I zrZPO(wO=}ur^})T?L@6a){8UgQZl30@@Vnw$Nc3rL2xDyHGtgKKc`F4z$sqrHrZnK zmHi&xo!_{{S;WlAPmTbPmAh#tc_wy0&ILu#xBcVA@SI{C_xD-X)G&UVO) z3&Jt-P`yTyUvo6$?b=wmk!OpByw)nudoZVGP|B zJU=OXeVw2T+?!{H`JcnmhU@Co{j<;L8hgdE`B#Z;`jXT85VcW8@RPhp)Z`Aael!zsiwSX>UgM;sa7R!~tcF zfrwM`ym=bo>{^B;nge1>f8yk0!Dx3h5$`Oy_wl(5KbS*pqOY)ue;{tPVa?B!ff3{! z+j9-({SvQT(z4r&?PEA|gLfvMzV&vlCx2P@_^PYK4H zd5L&=H3LU@{S@7c7Vo;`J-IfW+?$@kn;95$y$l{Z;>6m<9yjToT*mX0xskji`McX^ zqh&as8^b0B(w?j#3bV)h8WGaQjJdnx zBxtN14)o@AHHO|&zYMHzYsS>{Xla^ahoF5SSUWTk>qcgxOF$VO-ij8{*`xUhX4sIY zsvnqvCw^tHR>nw`2LCVrZq4)H6+*x2cRq*5#z=#Q_E>u}5H-Ct$X-VuZdY=ttKwzX zO$SU|AB0yY60zxW1}@n%-)CW*++R*_%Yy(kcG95H(Mk{g3tOtKInsuJ20!w;$%BP$=T}UTJZ(jtKwwzkmL}U;lr< z|KHF2=LYdf7<}RJh7A4C28nu?fM@!u%^SF`UeZ7xdGxnFEp&MrZ*~QJncJy$_a5enB^142+U5ftpkgFG4e;#l# z$+3-FSu;Dg&8D!6A7-`FpV;}kN9yo1J#Ob;yEsQ>cd>`NjsEcFCHfmD*6Kf8@YO%P zfB9nVR~l*Fjqb!n8oACrWz`>zRAbgg--jZ`t>_KT&#I&`KyX6#n|5 zk)QsFVz6VsdM=$icN63(^PHLtraxyJ_b&P}Ln%im6{8cRULBom|E!atAGK1rOhYFM z*U}Ej@@89{Y-HYGyMgSXyv23CE!Lma8zDHTuM5N-Sq@zh?_2_CK|Q(-8-FZB$~9H?yZ|(BIhGk#1cj)E1#AdeXdsAjI08UZ)CAI&=U zoNjb0@@FHs|9!P$_o^|=TCo~)e$(-DCIkanlRw^q z8A@--LE5O%pf|IVxIfTvjRuL$wVY#f&mfZf&K+2zchkb3?DJpi=*?mMKJ+)Ur?}^w zpU6KS&|q~k^D~^ZDEP_zr{`Lv?&7`!T{?^3()s8|HnFZ2+f8H^`|9xiTO!6S=4&jq zn6q1h<=$F!jHBb=o(B2c*G`CM_62`F-eiRTaU<$=V!h{!5jDmeG1c=iirtO49B)J+ z>vcJ`+2_mWa?S=LwCuAzmcgD2*6d$QVf~{5dz6cf2x1*=2VZ}oG!svQjj%WH>xcCD zOy&M`O?ofFS>tywq3Lnf_?yzllf@d~HzTs!nK1vf34NC_0xSMD%iO^V)bCg<2W`vb zf!YFnR0>S)XO_(`6u9hffm@wf<{--{zxm~dtKw&x~(5pobW;Y{(jhchTg`l^g|BxB`e{J zZcCY|`-;3&7&E7jFrW5V6mHy)z%w1!`!10PxJRerzu_pyn)E{Mv$V*Gz>5g-R^+M1 zkss)Pii}m=DEO2ozqlY0lm3asqAkpouEqUW{@wi-5$L)(0&^QO-_VV2IX~uACq*Ee z`^B~fW(-#1*O3uez`9to8j2h9s1uErLhMq4UfrPE#}_ywwnC@`!pQ9%l@&^tbO%P!-A1% zSZ7W{gVAZo=u1v=3*Xm7zJMI$HnNUOwx%P1zi-4q*8Q7sKVnHbx(?38qyxFASwENg z>U74<$VCY2bQ_~`(RDAgr!#Z$;Rk(iabzRf=AzbD=1DckMN9VNE-21HR=+&#&ZAq1 z%;VTS^fCJ80x@|QSIX?$TDfREA`gR8n4xP&&ha~cS3EN(9P*H~joA%8%r)$g$MeqI z-SfF9&d!Bv7p2^Ebdc=lEoGG2Q9gS)%GtWD<@!rUY59*zdNgp5WG{Q^H_=|k|7$B# zD>#W?D`zFa95_v%uSS(~;B+=;iu_KBrZeqWg+ zy)Tn%+x+oQtRFtuli|%|E|-lzCLZ@CALWY*9zJ+;gr1bMe%R#8%=UG@$T~=0<0L;6 z@g8c%`=x4aAFMpZER;ijXwlgh5vhK>2mF`|;g2<7p663vRC1y>^{p>64|pH-^+6Y% zKl5bych#6Zy2l3}+WW)G&ktq1KevQMqO=Y3Bgq^F^e1P-n!yVl8RDw+SX3t4Q7IBF z^TJ`%i4LZB5%^g}?@n;>^G|4t+#W^vD~1@p~1&>yuh0%o!fhko(CdcA6=6@nkJtzX&2jQ5&pQ&K9R;m@U^TN7rw2c;sqe;TI#NX6lw^gd2bC##T-4fp6z(J&XD_ng@- z9i_)oVNPaGDetisM{{v3qFgW4anO+`Hp@ zC9mQ=7o3Y(3vzMkI{7Bva|x^RFuUi?i`80p(I2Wt48}EGU#C}?zVhrkh7Z%1UT9w| zJ@#f*GF+`TuE&*uUT$lKbTq846n(K{(UKl*QY#v2sM_d172k9_KBv?zvD#hz%2hk{ zTd&`|FsC58hi}gI9*^@P^n-Wr(|5SH|6*motcxx;OWdYTd*b%COsW6U@7jflE$bQ@ zc~moWm!WRWn{U=HZ=*Eas+uCYjq$R=I#E7lB+Ay=NpfROl9V?j%E_5pIrp93#q7S{Uzlzu!vn5$R_18%1NS!>Ws1tW)ZcYkI zkaQod)NQPhG1chk-mZ}YNeObtm-!FOrgoe_M$)8_c=pR|7^jiA2i%(?UlBT7g)(2I8%x4Ax^O3_mfQy99tcc`I`(R=afrR z9WgLdiGTl6qCqmf-Xm0a|CCv6-=f8?W&}U-^E^tmbo=%b>E}?klqQ=O(tXXir*Y6}f zQqJTZZiZm!cQsUgYWNJK3u6znr^D3f>q}1YF8}*26w`Wg&iI)eBVFD02Sedef%Czx zOoi57p6L#(1DZ!(>pFYa%eIJc|Bz0QO;TJ~bo<(5{ zLVCRC`n9$eO>{c!K1*MSk^cQ>iI`u=_1^^zCUDMp@wyhLJhe!_ZA3BmN9zO_aksY# z6W-CMm`w(edvSfw8u9uF-Q07H%p{<9n``}`d?O0#8gb8-Zbj~6Rv5)SRpzSQ-e$xb zGLU1Nk@q-igxQ6Ack_%`xP5p;kU(P#IIF}4G z;WWSgKYm8{*7PL3c9HsvouwIhhcVmROHcN|#ND!hnbg~XL{oq>UhZ}Fm>G8Q<#`(`b3nGv} zUd4YVdA(R>h2A9>H#Qvy$T{G7Iz3y=q$FQ3HkR{?{mfBrz#K^DFF2FVylMKaaI3W> zcC?cWR|m1QR7&+DO6kmVF|%GdbXaH!H%&Q=sHH$pIwSqg^LKN8XFu7W`{DjLm*b1Q zP5fZ}jBI=k^S2G*XvHz6wqqp5{fWd9KD!Inr^99(`#N5yq3(%GIP-$M0p~Tgc6sQO zl#4G7zu>$DeOLW*(YLcomRWX`bNco&(z>(!ZqQD;RPP{T_R`&S#uC>TlR3StfO}jy z1o1P>twTrT79Nk8{WcBB`_oT0vYRia4~c@q=_sVmqI;0@#)(Drf>$SVsZGWC8R@8z zNIyUV8H}#!h^$S_?oZ&^LW&M;jUMjzuwT-yvY)nM+exD5op=aA4B*0VMh*~WDR`rZ5ugDj;DJoMWJam z@`InrdKQp9-4KZb>GYu$@-zF9MmIn6UWcb6#qtt1JCm0WCvQrZR9?R?sGg9E-%Gz> z$8Z-}-?_cqOJ^pyvz^?o(?N`XJ2P9vl6eM}SU$;;S@LG-!hVmv{VieIIs)+r$%BBs zN}S)%cK_@?dlkSx!;7H}z7u59&nM-W`SeH0CKE*p?u(=oNlgQ7fOb z5+#!3RWEw3;wz{yV6qb~vo^5HN`;gqtPkWnVo4!6#&K%29M3)dL*(OTsu4IM6odGD zTuh5Hn; zjlnxvbBbj@u0BO(wMvrX*7P^MV=re?vaJ4*B6rE9?8{f7z?E#}da@xul(0-tp~tmQ z1XNqi-exsw^-?3-i5|kfJe~ns_=RZ^ypJB1&(eff$l=);F$T<}7yeuL|=$}j9-@Rl>8qUm6W^L4TN|wV5lO$o*QAy~c!oufH zz#1pa?L*FiUq}8@VR5n=?W=^MOQTTkgR;gkS&cM~YvVaa+z8fU>mLoyd}YQe8H@@? zS)fA%yEAUOz|KKfvSJ zJU|D#D>_W>qr=B(bfxVlPqdVLW8cT{wlksZ0~z@fk2&T)M&k0v$oubH)U$A(N*3hZ zS>~F?lOsG##__98{<(Hsnv>i4;jEK{{3O{KeUx4!6+Ro-2kWQAiO-ya3{oM;h3BVJ zD6Uo}2TKNapHYpC9K)-8QDXx?r-*g*Gv<;{xvF7ZihQhv4l8**dy5f|>zVMI+^64r zo~H>$_TMnSv`pdN;+MkxQxyyMtGg`RT~?D3ncyT%3!4eU)}_+;4iY@Mvjp(Zm&PdY z*=UJI6%^?3tW-uHDV4Dv7RY-t0w=Gs*KoN%x;OS`pAy}!<-v_IMvY) zK{I@Ct0H-7-zc==aqL`ArZJyAQ%mR|w2DG#ch2?uUBasfK6i$(@2O8ZOgrgnyv6nI zw;c37L3dFQ$JG_&<@D^~JEr8^l3wB7oh0>uQofJq$c#@H=}V@2{W1#->&!8Ax+PX^ zwtzmx0*74uaqJU&%A%Ob&9T1!NFLMX|HgdsajzobcR2#~C&Teq>quyH`3 zz1@j))uyDQ!tQjmT9JlXGuaPyJ{P{H^Du(z24}9_$Gy+PfjRAD`J>LVqI`RCWgV(! zlMYhphLe0Nv_Qnja`-TqPUvcUR=Zf@%u);7IOm7nb^Q>W?~8X&*b5rxi-{}zvFhJQ z^!-EMJ;(R&!z1BoABk#Nk>muJ!~HfD?{w)n6L$%RGwIiKWB#-Ue|J~*EZC5*teb}~ zTj-kqn1}DDT;zhUgM8ZHA`$28<=^{ubP=_c=-!s78exflmX?W*Ec~{oJXcqlLA}@) zJumZ|Oz^{e_Nnff$2II7e<(TMaA+Qd@|ICJaUlu^J~HcqYr};{(x4{;>z$pBa{PC| z>vVi&KKR9NdAMCE4>P;vL3JY!A2_BSXp)DcUtHzq)vnS;<08Z8%)ZvQGkYJM+lO;+ASu)$o5+j30U|RuFQKIuXC)gy@gGdg|rJfRlwyW6t9SR#h4+kZL;)|Xh zyNl%Y`26{LNrTGQIA+zqb2BuyBue zv~V94p>Y41NskSmg)=#pNqUM@+Mc)M`XaV6tSqRlj-M`c>h%e+g3`{2YUlj zxi)&G#Pss3ak5m6!)?hjZe_1P5_{vftMNDI{#I+~U2mhqRX5gm?X|4oks-Wd#FVin zJgfH@Kc~{|TjL46j&uz3S=gQXBposo?iN$Y;X7HluXVO?-|{O-#@y1#PWPi?`6*dW zFVadzL!De_esS{@XZ+?f@Zn-54qjGbt%ag9=*>z&2_^=fg9pTR!* zv0A(vuEp$R_SoyRII@g2=XNHv8E3+-2JA;75-rt;5>;T8v+>!$xZzre7t`$nky>*Dbn0BaU1D=Za_FMD53T z_TEVEmBPJcbNU7wS-8huRk+_G1K*^Zg}dfOqQu-wktKiVVV;*LzdP#0snsz_AL4|0 zwN=O)r^3WLTtn7%M$UC5a(<|hurw6y--lq5Qz&Z^YRnz|-+E7ndQ(}a=Q*l%TML)@ z{OpG7aK=d1bJSzh=X&UY?-P{DW1O$Waf8P(*3-hh&vH6F*{{%z=P7QE!aZy0F>&xu zk<;apWdPmF$L6y~@LRI@XjK^ZTZMN+x!xVCL~)W66gO0uo2F*}SSVcUgrdgnP>idl z#-tdIu>tH~`^hyQ+1xezxDP=`WA`8}`p1~?Ws(V-uCYJO?lEexcE5YbW4Qiz{nWN_ zKS{>&1dnGmujer4h5w&**uN>w<*!2pVn1g%>zVYRsZ(*g7P+nI)^e*6xg-~IRUgBk z%cQ4F$=+-4`qHn?PpK9@4DAPm zd?T4Twpa=p3`hFRaEu>mz|Ak&khM)EyB>Xu#q8y8!9KV(sVEF#9<&8>u|E}xCfyq~ zJekMZj`<_+v(fFol?-L>^Y40IsB<$6eFDh4k&E2%t(8Q5FOp-EhGXB>Fr?KZcbS)s zO@B9%6NW-5EE&{0ue66zF6;A*~qdvaS-QpsIs!+AhcQ4KDZkG3LDx9pyvAQ*r_dW8Z>yF{f5ZH;pV+J(pNk3-gCi0=QNZj9& zr)$T3huQ`#=I7FJWPKTOyF^Ztdwtm?9G|`#kn<%AwZ>UXOXeEe4Ddw?`OWb!4RGLj zuIy+pwcF>*+bB=;aSlUulK~msv$67IBk^Fq?a6YU=szS369=Xtyh;uQ#&6jX zOE2E)aEv9lHDFjauJ36fxKt=V?Yz*F*I{FRj+1yi>z7%}(>mn5%*-QZj`K@va%Y># zk#%S!!SsYy>gWSK_e#p`(_?o`7Ai2W*=}=@Pu^6fC@2c;stCHdBE4P{G4p|r>z zj(~nU(YSmnt{HRCrL2yOr_Z!isTU?6*@>G!=;d6`T;MM)rCDaaT=Aec^AWv`7Y*>g zn+^XhO{MTcf!z7m3l4GNa6V^XO*$KEbDPLpk9@h^$_KB1@;vI(zHVqLt+o}5U5qEH@i@;1rlNf><`kc6EKQsWrTtAW)MXuIN^@rM z(900psG&6ZQ!J68p0Hs3`1YbySj5w_nb%M{IhILsS08-i^*ri3pAQenOXf6|dyjsL zRdf1DJ;E_S=#Jo=%)!@Mg4X?!ZN0qU{grv>O7g|mvXR@xUV2y;$i1@R^jU}DuuUp% zYP0BbZY(XY7s=UnURbK-=e0?Xi7&ITfjPy&UH-_HRi0?_kk@mn0j1yuN(c02eT15sg^Wz zD3*X*p7=3<-hyogWX;Y(Zo4|tdRl>eF7igylW-g)|9jIt8`>|{GGNXhdA`dV19|^8 zqu26q3v!e_n~1mSk1U)%9K*B2V0>?Y_t9+ZbZsbw?+e5+dKl`A3WHTdDmwS0XLCg} znYyb`O7_#+=*|6t3e4$#n~h(c8cS-OBI&f4|6gTc7+O0O{#Ja>RI4YJ)`gPt$`_~J zhojyTa)RUmcXF?^#JflujPpX}Zea-JUfF2B98_|wFRyZoWCMBdasfNxFd-E+{>s7P zO7&z_UV-fQ9*%9~Pmid{P4}UHb6`F3qZe}bm|@t*>-Kdm-tXjRtDLPbb67Zk_s0v? z?{{KYq5;9_*%^99z!)1da=JW?0M34f)c6&rjzW^k!byW0_Aj z;zqU-OOFCM|IG^r$%79GVGdN=9Ncz}m5$_M+$>kYbR`jyu9=A6Xhw^_4@$*$wj3wv zFQdoseF5v6HOMFSjFIX49PnaW5Z2byVBR14-QJa9$If`k^RQ(WkQ%>|>1V7-Z`xyW zOo{YuwYJCjhe7D!L&wll@@4jB{Cs{;f^+N<8OyAny$J~B_ZJT#2iGlLzE0-x&luR^zMP6yhAxS!KkIqJV1}`UKa%cvir9Uw(M!LclA0-4P8}c>p z>19hZ<3jy-xzD`jYR>|>eoDkwzW>DUX1vLdmjm-{@&Ax^7G6>3Vf&uJT6gUh!6pYp z6kGJU$68w&ySqE6!R`VE1C|6sF>@LDw3qWw@_Tlo{ki4z~?M;EN=r^7TvqErVX-rJ0{2Dl!MTl zV`bVKdu&-vF3&)(nU-s~MhbOOw|!Fols!iKEkom9^d$DnLD+9{m;C##Bo8>c6M3i@ z9loB*M&8{rRM5mqt()ZalIXdsOg_Rc8wpm->28uBzkk_dxmO6LO{aftZ#MSUSE&2G zKPUy(_ITAf2=z0QpeAqVS6!hVKwshY(e^M8T!vHR>Ds+zAAeVR-y##`T$UX&9xub+ zV|0jFpN%(8WoXtpUebN+G3$OXd3YVF9VO5BnEuW7^ccQyU|lPWxet28yvc^um@+I$ z+AoJzIbjF6lJgt%n6f+@k;*bewoZ`igPc%ZyA1vEnX9{!{zqP)=Jn&G^xu}a!@Tcy z8<;D-IR|pI4DPk!Oz9L%_Fsp7OR|v^WkJmBJ(5<~0&i=DVEb#<0qk?Qr}~Y$ z^jGfc?|`sqa-d6eaM+py|I=mI`XoV~k+?i1g~4@5qvraCu&>Zu{lu&`8c4#j$oX=O}}9a=8Q&@ zGyNGWarO>~KgQ36_d}~2&Hp>UXX*Kf6{BY zV84{su*ces!I*tI2{St6U}ih!iPw&kzNPl?_6b4lx6Gs0-$l8RkL|N{=M3|BgcmvX~s`G4gt2PBRDDHV2pa`Sx*5kiKxhGiHr#`Kg25@*J#P$1}vE z2@<-_30KAkV_9>4AIE3o_Db@Yar7sSvBv`I5KIZwVcRb9cS#)gw#G>e`QN<$p*XgW z_gi23WXI6&nZf*S^004rg&?+wyrc&`mE`Y!(T|zG$euYr^laYJF$;_wcSae;rYA^g zO()!*K#rR}%AMKt&-z*Lcvyn8IOKqy{{$nl4*Afh*|?$M_px8RyxD7q;UPnF~+v=Pu?)PZ|@9+I;?KO*R_yI$S)qU#3LRBY7$WHA{J)JR%3}P=?$gd!l7~`Tb&T73c;U6N%-xa%B+cdp&Hf`N9&!jn$?%cXd z#xQ0lN;i2fs#7&R$W(B;MeRR4O_gV)CGUy! z)W+UVoAfO(J@cPGGrUjVKU1!Ut*1Qhnbvbby^NCMjnkJlYLhW3r9;L)4%IUj{%Fw6 zII%%S3)#?hSHCOijoBSf{O{_n*r8ToSQkF`l{0pCVzzWY7mVwv!kHwxcDk~*{lXd5J2}xY?t%fAnEx=H zeB=s8yoz>4hq25tEOy4p&0+X(nzsS%E->O4Q0qrvOj8bqcsTe>-YK1((DJ~bT6gEZ*7 zITU)<#*fTo4X2?7k9+eh{&E;Sw9KB^5sF(n4fI1a%sFHJL~YipYa5~IM*s0+J+85~ z9J7!4e(c*E&d2@wu?LsuRSowu7kU}_#kB^!U&RcKd3wy@xzU`PdQ5mj2H2VX059l( z{)_#(>`C1)lQoDz?2&E9dQG^V{Ffg4HX6~1^I)=x=k9d)yy5E~=6O$bvchWy^S!WU zvj1uxE|#Y&qaO31hv#C`G&A(9Rkw9ElgFb==QSC}?L6m5w(OMn@t z{-%R*Yc2{)bFsd&8I9iNB8UHds)!DUES?{o$icQu=1MDa;jg3Dhwh#1Xu60`neljH zE;ie+R{k$tKWACX;+nA$&-o8sY9;gTxJq(&l^odQCTV@i9eTUVOIKI1@8v8vqEu4p zva57>-bR$Qon=UpqclrzCij{;N+tG%H+|tQ*=ro6`m+|&a47Q|_?$k>kshyaB^?#6 zlEkb#yDrV-gV9dXA300A(QXnq-bG#qIf-wsi!8LXkc*32Nl5dSa{e~YU~4Mq-?K=w zNCiH_y#&f=Kn(U8DPw69YBA=M!gB&HDioX7+w$Tr*9{EB& zCIE5s{V^tRhpJPqFR)m;`x>#3jOQybq0_%aMYsGQ!-c8wNQT4qH$YhTR)CO*TYdzZf6a7 zJUvFuv(RHVxkc99qxaJ_;AVpTdh%4Gv*5>C#Vw6 z9N&_OH8;p7`t!f5)2p-4ghMTv^SG28SCR=&K4jw0H<>8&&&1~<`WV-;Hqtr^4>cyl z@^vqgeenC03F~hrOgdDEORbCGF{2RUbLiw*Uxf6Yto0`sVakC*6nPXP=QjV%x_|tp zLX25jg#GJ^@Ng`%5xAgR6Mc?5S)Yz8#P^eY&QE%zYSKwJ$xf8Rn@gR8Z6uHx(bK*;O58nn zxgXL>(p9ZwL{%3#Q>~>0@O!ZMLo3;HjIN-Q&1F05CW8k#iBo@Ok>#`zYezaEKDCl< z9~(=ZSe4{FQpudYtz-zZ;aAVJ<@e4(c4axs0l3PAJMPk=eKS!STS;DugY-M(C|9Q2 zlY_UDj#12RXO`j`I|VAQP~sSCRJRW+(9>IqRc;C_^(m8m-T3_)O&{uKdK?E?WboTE zxs|L$n+FO+t)ye>x)MpR6i9AZCMz5M7Arsc8^0@f#!1K0ae7eam5C#n<8>o`%UWyZ zrZp&&F$W|Jd$OK>V z#hX2>*|_>+&s$&ok?VsM<9w0Pi1jySxsR>jM^45Mmc_m}3qOtp{-|@&A78d>nI#kj zZKxKV&yd$8@4NMnDEvXrrB5d`gCyUZ{p9zm_+2cKheB&B^4=-dO?3M{V zv+3h_$uqMRtjk*QyLa7$>oIhb71QT9&jg2B?@?BPd2o^BRMr;YXc03l?vd*?7vd4W zI}%Coy$j7jr zd4v8eGQ}VI(67oftlF%ZZSW=+(}Nr`pS$Q{0sd%Gh(p^75i-3HA4%`kuTT2NX`MXXZj4F~Ze0G% zy{I4QKY!FuKT+4@`S#QPv~#)LGul*-Pv1PxJ-x>VH$MH+ntB;M zG*8lWWo2nIVs>^7ja}tgf1^3ASzza`4Hu-R%?a3>t{zlBGsGV170V~TF+Ez(aRt~)f2_(GW%V28s+rMWQm=g zBIUm8MeUa?hl1m!+p9#`O#r545TMeA2(4noS zi|IPoiaG34IYl>9P#A(;>F>5^P>JU~^@BAS$j8+WSkv>+;CzY(5xyF18_ilD|J(y( z7^ZpC?|p;$lze=%V;J;v=mb}3FeRLSW{C#a#x*DFU9(yD>c!rd^mn0%;kwb7WI)5= z20Flva37<`KfPHSByUriLMG9}02AGbed7(N%XQ=uHS3udm|<4Mh((jgov?oQZoQuF zSOXU4F`t?YQ7@j+=@%RD(8_=MJ8`oz_M0})pi!C`qK)l3)q`+%NJ#L>9(Fb6fPM7SVa~?*FlSRN28FoCmP#V zkR4||{VaKhU2@!76Ta}*Rrf3;#L$fx%Q5!PBFvpx zglUWE{flJ&)#pNlbA0R9+Ere5RY_D!dr?_bvhIZJnft};_OuuL{C zw1N+v$9w-CiqMbb>^BC$Ei?e-y!3k4hH)@FXMixd20EGNVghi1M?^h&vadae|BZ&1x;}t=;7012;); z>n0uQxJ#iZ(f*P}EFTqUmi}8}+!dI5murD^=7v`CL*Z4fXUXrhS;L-yL%t}C=5@&@ z-(VMwYc;ee?x@ACN96E3(D(H<3;nl{ci3!V-b5B!k}3T9qW}%Ja-7eggUrPDMg}8) zbrGs`bd$#RZRIa5*EJ>XQX#XAB(H5HFZi>2%~8PXDZQTKmDuB44pyQ-!>i0z?dFdr zpM0^kM<8o@WQmG>QBo}mmAS?p+mAWZoL}$y&=(o0MXfj!{JH+y*UE$r%gN#wWHBd_ z@25u*Z1ak+@J%6hkWX33dCO)mdrr!Ckg43aL>y@+3a{2OYEf&M)!aemS*$Sni4_hH zw1~@0CB{s&;vCF=s0qH9Rx1!oSNY@Us6f;?$lfBZ<7--xeWhn+<)7?*$kXE84J|&l zB5OJN97c_#ugy6NOJU;mrE_aH=TvuoJ{QTs+83egcdk?S7om}*05932sN86j4rlbz zps7*rc^Re62!rIl;g~#$+{Ivy-wrPLyMrqhZ*oO$C%O;!YG7VTR_~eyH*PTtVO%(J zZs@V%8Chzrk$E`G>YQwV`#1yax{!yfWk%8ix?hj5&yB9VmF4p=;{{p0L^6#j^fGD` z>h%klUEEZuzW1*|emqW=f5_EeT$ds#j}0>Syiw+>UGX<-`cI=&aIkU0^uexhGxI#* zY&c%;ryt2c7vfd&abDr@-WHDI)&{&i$~**Lx^GX=Jy@3<#%nSdwR0h@@({fwmuu`? zytrwGe-htgyh6Q^4B>I|db5@&)Tvv@V-(O+6p<|1t8`MxZ0Erhlck7#1HFf*h+{=p zsLAJtG*e+J*}-`RC!~>W{84#12F+z|aeXo%tHO}%%Ih;qgVr3ozgZjcme*zZSOcmp zW_IymBX-5HXE2%L;cPPwH0FMMEnTyuSU0eC7T;{28K9e@j)U z*O46@{ga;+^PUHh3>jW+LI%!Zj|cLDr_W6v}>LUaaOHx*qgnn z*3K|i)nLJ=FgW}syVEKh3pt1O{>J{$FU-ZPWWc$<$)WyZz@=M8^vE5KdQH7^a45FjgH7!&428CuwkUHnYLI^7HaA zqVYS6Cx^eCb0g=;0INJW%*@5$2h1?-qfi&}J&Yc&RD1PNs=qEG z+xWsklJ2=k*)tEh@PYfMbI!7NLMyqsNrBBvEwX5*57W8+bYpiLw@j_ANEZ1$9|qCWR%fWOBVi0RWgjxT6`X=g}l?EgyT`HP795T z3CB2JG;pmw#x1V4uz2XLX6x8e z4kq(i%=h&#-GkQ@SWV7+)KLXij{YSclgPgp(Gz*p2g&p=zpUhs=6iUy!S{ANBMP3} zBVFbBgKxMNy~;;pPHr^b-!|diMY4<|xz}jH-o*&=@8#*wy-wz1P$7DBDuUh4LUjIG zh#OVt^YwO;xB0E)LLZ(xy>OD4*>3Wl4$FU|c_wt8`^(DZFmSdK+8YYo%2S{R=ZHz( z{?Kauaqhb>>L8vAJUxy^g0J@Q-w|QRjR}Al?ZdnNF$8(T(?2WW4!tq4rV3UI#bEgPS;T;H zW6sDC`XaeE4LuNzFM2IrHPXUoC42RF&qU0~f&;J3kv>_7=UL7*NA4$wa6a$L^$xjw zciZ={_GiXLGp;)d^wM~cUb+rTmb|!R`9*hpHob_idA95^!3oO0nB&9m`H}UmxW=>N zmy0#XGlXLS$7i?E%;;4v$0^oWU+mGN{Cv(6K}PgDX22)1gkvJ<`#Wj=AEt577c=Hv zx6SQh6Br1F|?4W+uy? zb}qPAM}>A87qnl^^KM7-gPcFwP6(${T!T6nG}wMfgNYo2diLU3Gv|qedF1c8-fvJq zzxrGw3fj^!%=6gme&ngAu!o4_P6zgeFYA_v;#&&!xMYQTWqqaEhg|+hqe8ubu11@7 z$@0B{PPXZjW)a3v&?hapXG*!jp-d6<%B*}R4`v;A6Y7Wx-XeY6v(|z2;IvE z*pqcugXI&$nbBfI%Zqfov&KH&$%wtqMue6#qQNaCFqb**FM;5i;fFExmB9fOQzJwx})AeCCDN~aLcV>eaU{*)O{+%tyd zIb*q-6D~hyFWmVsCUVZ`Vnppk?u)pW z7`4TW)qTwPS<#FuOY?BJh-cXc73wQ=FSq-uP-l?E|G^%Cf5?08;J&!7q{^EEsWSDr zLF#`uicxKpL@PID1*;HRk8`^}dj+n#;M59dxPGFqz#N8sye>bggroI5UaJ5)`@7RG zFp{5FeKPs83~0mmc8q&Cs}M6n+2=LcHxHYV+0$=x4H+ z)H~>n9MG74>Y7L7-ySJ4gKp{<_YAVEhd~^UvX^9|3QM@pjph4VGR76j)5z$u_Aqx0 z9gS_nQEnYwqo=w5e8#=*O1d-;v0rTu``+&JTAkIS;spa1@n>g7(f`~f5BFcvt!c-- z+h?wU4znMC>z%50N;P=zRQbivj;!wg@{Biz)Rp4mVwu?A2WzH9Ag?=fPRS*yTpCN= zy+7o{8gCpw5s3nFI*J9%r7hn`@@oH(!v=4j{YT>bbu!#j^6`WDzb~`C%TYb^l7)JmWg%$;LF1 z{gaAi@IY^z7+WxhbVtOj)wfDwN@^MRV@;dwFqsg5H zvU6;)DDHcq6FJR7zR#VR%u)TPg|u}0DZ^X%AZ-Bm15ugqAdFG<$!_$QW-VHHk#&AbS1CCHXuh zcX_)+p3R}>@o@xd&CNtgy#n;EXCumz5}8}k8<9agdpwzeitF=%#x^pf_Ybk$@!?qt zy_}{D4CREKiF>Crbuy{gV%+Rb$ZxluAk!Z^ZaT!lPU!%*Ws1&TAVvki(xl$qQr2 z!`i;)&%N^wP50Q!qFKLWUa1deB}Jl`??31=dBZR}c}TzB^jkiNJIP#v!{lnoqbY`4 zOYG;b61UbHZKg#c_*f=xHY`A$qc-xHYY@j;zG#yi37@ibJgdy!>Ke8(bxf%YXa4fv zDH0Yz-?}%IOWEIL>R9GhFNws)D)d@bEI{=Q4J0+V z;KlI>e2UG$$f^bSGQn9MG8cFYbAE%gk#N1APLF>+(qSWGTNg{8j3H!0BN3v_K+~W3 zIDVk69J%&Qip<_*W&>5Z!7<_?jI9Q)}V&i=5GTR-TF z%wkTuE&`b$B8RO@2#7g%A7Bn16jd1DoEy!;1X+V!f6Z^-rmv>Wz2gVe`pB z-#d|y)1i$daNZ9Y_Ft|vum6~s4D{i+^z~?Cd3A>O=Yb)pus;%caT)k=;w`ogu$B2P zKV?I6Z#49afP1%0wEV=p_;(HIY5gVloqXs$jfC&AOf-sPX3+KqvcB&! zUw?Z_J{&f;l(_rFlK;{NgA*dLnH;MPYe*j_w-oI=j!TWn4;Dp`P2xHHD2|_2Hc~CN zL}q^D`;3U-oRxtW!}BqEwvE(nUM9oIGnQ3hU7~{t?b|XV%-2D_{>Lvr_lC(7iJUf> z*jlRq;R_l_kT?0$aPr7k$v^JT#4O%#-!|8hUX{Lz>W~j=b3AEOmVqx1^HIB+wWRPq z={bq>MOp-Q-(s$PdAbHBG?i*COC*NA(X>~QIIQB|_dETtXeo-sA9C@X4-~x52h7bt zr3~Jms+Q86j+k$Y$zA3~U@pf2W1j*z7bVCc=9$*W4u*OgeQJMYv)_lgx?Sisb8*De zJ;7+QREJw`wsh zEb!c#AcN_5J2aJkuA$^#_UE8hj6$vKx?g7bJ7C#1`Vi?29CtSd-Ye*Xi%F1Cp)GM} z^fEl@s>7?}IdEuJhFJ?^rF}TPW_BS+U(dX0U*?~VWPeKHehHZ6h)>x;STse4CE@f8 zRg>9JMgC`^mOAp!%5*bgQI8C7$P`9i(q@<6b#9#{m<`F-_rGzLXrF?phfJlN&1AN1tZL zAo%{FNBei#PzPFYa$}MVGuffSh!8YUk}I5_jgD?*nEd{LZ1%9n@S!1yNY=slF&jNx z6zcIO_e%xxiD$2p{pg~{Xn*DxIWbqdFhL%5cR+AN7)sxe<0Efqe9QN*PLM144rJ;> zu)&;!;R|!{p6_$i-gtTEX%G7}=5CX7T-`1Q`)e!Ifo_QsSY`+9giv~Sm{aVZgK^8s z&~`f68}4JqnL_buwjP7Wt z;Kc{z<3b1Y_X&bpOTS@M4g#8Tk5M~GY{og^@cB^8IzmrhbNT`Ed7b<2lPBvOu?@`a zO;19#V>~B$UxvD!m?!?3dDir4E*`?yX~X-3Je{E=PEL6`V%&}pblJ@J$(n+?J@4ld zdJ^B+WBct8I4N~dUC&091`74i6rBtlWsiQNgYoYt=5(iLw z@8t7c$rmrQps!bTCgS{ zLAEz?f|nu$Z$gsbv6Mc_Ze(dKa!-B;*`{XhCyCbWDq5qx)`#QN;K7m{wy@&gATjJj(%V1A0>g^xd=xj%CpkJKK zuIa?Q`4E&f(?NMK8!p!^n0G2x!d>ad^bSHd)^;Ax$;O0jWy~BqC@tW?wM{5CzhsVc zZ|2C;qk1~!fb_a;Pai-KYTae7eShBP{VlAM@jfAk+p$du{^H;3UAG+6_{Dti0Oq6* zc0kthAo#4%p|FfO>`5Fq?$9&4fd1BTp{U1kV--D;706fiTN5uUoE+%f2|=G8I(RMS zI1uw2clO4KO6!0j`e6KXhq>YBauCmPsm9CwlAFN4S1F#}@jp2X}Lvp_KW`0~43Ujdzjn|O-Uc%gY zMS|Qe;QdT~wgInyx&8F#`dIM0Z@esE_S~7vq4?gCq3nQa=Ur9S$a?s4@{`k?zCJk$C_q)(uOF(WiGJ;*jXt&w}vjN%W~Gs=DG zl-}7VFMWQmkS@88)fujFo@u*k%&C$z6#}wH>7vqZRDbkZ(pDSyOQsKE?+Eg=0y}BvV*~=iC z59*{*d-KgWSl~$u8B;Be*jvQ2>ohWs zD%P%@RIvAS!huOnIMtN(hj3yY2RVOrHUApRO zX9QMq!s6ZZFp`aIT$Sfhjhs>OxC)LBoY0y-|1;0<>l}54^%2%Mk~MhIJPcdn!*DlW zgI(uXL+}X0gko~=cf)XVDEIm98cg#DhlMrhkJIVj85D*|jy#XxIZ0M}IQo(?-t{yL z(X2@aH4jJcROU&448x8)>{I<$^FLYEC4)7%%GW4<5X$pL4gK62=8uwnoI`OGHdc0c2tcT6a#dxU4k|$&lL-eTCgzlUY1Cl@L@x{)74G;8aFiVf- zYkB6-l^NAHm^a;=e}0V~sd_y=@y~YA7|@cn=t?b^p~cq@;GgSNms!@|m}^m=85eww zR(F|EXhrAFEwlZ6qU>d2tn8=QNL7j?7g#WpX?w#_c}>=SCv%j*HnDw*~|B<4zkBnC2x5KeD^BrzM0NaCDKva z#yN;`K@*vG&q1EkQMWO~B11iuh)?C7MqMU;X%@+%GcMw|5`X?pf81sT5<)G^$7asq zlwUHkfDEG}S*kM@$r)#nY!BA3m$Iha&>~Y8{}#goB?1?-PRjbg`9BqKyQ9E7zGn9X zW)|2mQ}-Vw0xp$FBi5Ox4^|>=qD3C{v&amd*}s4HTZ$6=kd;T)u%AE9KO@6v znOoS?8(sSPA=t+kFYW1VVV$%6O<%a#(j$}ahp)d_51!%2d{+A7+6SPh2W!O<0SMva zn$ZC`U-dulqaUny_@f-py^E>^;PZX5Tf14~jtO9|? z4Kwz(MIzQG3NvP~Usc#w-!Tf6;&~SRlfC{M$w~dCh38EA%WUIy4Y%QF5=KkG}xzamW zL!QNagaORj;^U={qu|qB3x%(V8IsJtt!RQKG7I^;$VBI zOt`Ngi#3hUZNw}r9nYE4S>qT&Ch<5~DgJ)yITO|{Bct_$EWudQ|77X*SY*OVAD*MX zG9mm7GjVU25cxY3NApcU3VAHnC7Simg7OY|gI4G8lsr^ujY7oFFT`SX5yH;V30KN& z=y^q$6HBk#ghHGr2epIz;kcjzTzFA{0mBOE;wxfLC!aI25F=R6INzlZKO>n*{fy7? zC_-)v)}*EuLgPfPVoM>+jf=2|+`!@x=3`Z3jiKUu?p^u&WFO52vXBi6v1&eZ4evD- z_u0*)%GTym(a%om9+8YKf}^PH>b{^HkD9*;0;u zbde$9u2Rs%Nv<)gJ;T*OBKdn|vt4Bt=sSJHoc7}?iGR{ew(WJ1iBlcrK(4*CIjWL6 zYnT(i$X;fQag&DDPEsz@MLv#nla8!$+*FZU+*c;HzQ3i;kTMCnQYKY$e~WT*nGEZv zz_{2_iL#}8(VE%RpMFbEeyzaRpq-Pj+!v;GK^T^xMhn{>%Hm zoF7Wg1|XU>muW$K?1dj{#WM%<1|6qg>A867hY{y|a5&Wu{uh0*XN(_WulmE*#TN&< z`C=aHSNQ||(J$5)!-ITbe(H(O{2C_wYH7mek69ROVCM8-@2+itw7}9~0xrAo4rYZ(sp(x6@n7@10>oA-?kambkls zj%{+G`81xG$~kLH?vqsrxai29WGBq^a7NJ| zuF(GC9zEQdzB6WIat&v;a>mW=E>QTXVC?UNh*2t38cbHC^M5@ubT1Y=W1O1`oi37H z3{_zyof*}>sW5S~3XO)S5W=-(rL`)I=ejV%$r%9$op5&wp9fdW8>2$dzA(&Y9m!ESkF3Dix~Dvb|C*4tHG%=VR#b4T4RZZ zTp3xAQyP4(yBxi|$SRH`+qgI!9=pOYo&P`XWf-33YS4B$*M!x=@x?a`^BaUAZM_B~ z6Y2QoYn~||jxc{cV!zY3t)=T^Jw06}IvKhC3$mvNWgt1m^9J-xrSGgJdt!q1aQZ>! z(Nm9dMgx3V>+Cy+KJSBM8oBPP5u`_z0eaM-$0f$B!)?A+-$VljZ`Q*mG#M9a7?G$n zp!o@MA_ti{)L_*~>J$;GdHKJRQUGnR8P{zfjQ zcO#?Y%DUbLGaUWMHSICu*$QTuf_*iS%r@ova~Gepe~cN{HhDN%{C_-Sa6NZ9SJ+OD z?sb%{hg`)up|xxr>MmPW(z!cYiO1u}yT>W8b+#3zBr744hNAShFRmVCj|LgJayG)e(1e=qE+`kr~?(qR@`x`afk_M3Xn@7Mq2{XC{=N znT1tcn^-u0K9A?Pd9DC$^Na9h49BJph3GYfzDSOBPrEtGl$&HO%F#JK%SF_5SXP|p zEH!_Z%3t5fTioDWcZ=&(lM?f4vuCD^j_;#%Hof|<7selIGxI1N{88|?7T4C2YuAuV zX-Yn>ix!*CGY|4Gy}4v%hK$HU+-(!Kk&mm3EI8dR#MEI$SXHNxXS!VH6cpm~bY?zt zol*AERWg`+eZk-^vn#a~Yr8h08ES>kJ*;p(mwiFZ4*hsZfzqMmVqa$6t>Fcz(;CqhIWK zXh0T({|?~#TFLc!pH9*E!FBKZB=#KaVn0A$CZ@V(VKYC!biS7p-HLG8s|fdb@0_n# zga|vXAL*|<`-E=BQ^_)SwO%yilBH!>s*Lk>!RSI4#2!)M)<+i{+2M+yInJo$POt5U z5L^ilXQqh;sqZ+(#c1%?Y9lhM8}W*q!_B*Ttmc`N{;dIT$QHP@&O;3MfSwujHgU|T z(VYHQ*38F}El})GsGp2gsPCLmsQ1Mx)V15`WYM)lvZ1eDCern1=$0Zz_Gt!uR^eG= zSA2AKfytS<4uLMXu#5~wDfjU|=tv^-(EmEe*Q3l_xJ{mLqY;hP8ByyaJzM$oCS7Jm zLK(-%(Pm7a$Z@S1eX$O?h;2d!!@-Q?Va)uwLjH_w!BW;C_Ow>0oyqR0N7Fexn;DSX zlBGIXhjuFZB6+UjUZTR7udbM5-3n{S7W@epJ{hcS>#d98QD){l-JrMY4*h+e`PyiRUa38I?Nnw&aE?hsqlEJ3)=aH z<2T<^5SbJQGJ6N7)4x?a9OGk*aN%bae#C&683trFH#Q zcSaSS(FBz_<6bQN%bdgi%%7+v5O&9i6yI|cb7qob-!3^7Qbge~ZW;vOVLE)&p zT!SI}d@4*eB7T?=c_uvyLkv*e<~dD2Gfqw?mlDSJMFv0fxEakun6*l$=lfiRx_1CS zs|1Dm5qZn$%s729)?J)J+KS_J2dT5nLC%hMm;L_EQYYIA85RX}-0vi>BD>c>i2;8r z;dP6yT=>C;5%|&z(7BXjyYh{knam(53GgT$u4|EW(U-oivcpG`L+F2TE?Pb9p z1*$LQ{wj}qsPrA!y%;3}lD0S@LTf;dc-bq%E zZ7x;Rt>sd8W@lXSkfRlyvVS4~`**U}^JM`3 zJxmtA1N%4=wV3V8GlOngyzr-c`8>}G?s6YYHIV?vP;)Nm%^lvTm?Hnchpoc^xI?0Lv7oOQTOD{doePXQeVU|VAoG*Z_Py=7+k^18}1wefp!w=>4HZmt#@LQfRTWLNwe*^Q?mB z3f3LY;l&*jbIr+Ea?B2Op$B>@_b~b*R4XY&jSKA48qa-)m5W@v>?GeGvp;u>i!5N4 z!k0bva>-AD+=CX$oy%)dU5Pu76zI>nV?`roOI!TeTSA|fE&%WNd4=-aXWv~dzFcIE z=tSN_f$U}Trb}~nG-kD7Pv+7r6m;XBj@Rn6DvN#T=kR4~A^LMppJgn9rI5azeVpe9 z6=Cyp-aoxsi*1pcENbN{j$d0#Mzc1uCs2WIHRu<;!1J(A3ij_<;ow>&YFGurV^09` z&ifSCf+jOC&wX= z9-OacaD1L^#zLNJj@ZX~#Qj`U2v(@=H!9S2%y@qDf?hqPQmy0|Fs**FG_69%ajioV zxt)8mUF6|Q45Da5t~=WW4LA38eBiDLHBOqNF1cWqD>kUFJrHL zv>wri449?*kF7M|`A_EdROgr!$@5vB)n4VCQB;?i(f5Rf;rimLgU+jqzTnoLev4qMP8j0oloP9M>_>Q=*5?7xh;1PLv??EpAsTm&{Y1D`+H#GNMCS7`{hD3bClIaFOJNV4tamet z?v_C|y67alnUUE*Dj3eGurAdZcZWFR1K;0<$Ij@zn)Ph1fo?1c!+6dU{>#`OHz^$7 zv_=T`Uq867YFmqaWo?XD9L4uHAP-+&^SpeL8Rw^P4K%@w-(=v|a}Eu^tWdAuuLWe_ z@ALi%e@o``x>1I$N|sjpjMA{NUOF1-pGeosi&$n1e08RSN`>^Z-0MDb!4qbd|NDgV z=g@HWtMGFh%gpI!;TRhmjz_Eogg6_}!$ODuS3UZ$XN>D7|uTzT~5Yu{m?7f6IsSUU2Cd z38#om^jcT|Yq6D(v>)=GXJTGfk*Kyc1C6#8K%3S`UON4haY}DA4jz3{SKBx3q!V(3BgR+p`%#vJ<5*kAnN zQv?=gWnx=2eQJ*zNeHc(W3G7NSt^OE$P9!}E5PEiMsjVz52;5kW?xPOem%`Vh&dlS zeHzMBZLyrY<&7N)%ov))p7<8@2ClM}O5}qM9`Ql*a?F{v&BWMq?=ay~L%H3EdCKR8 zV8Mm$=w_b@ZMy>cBI?UK=JU>DZgLCfNYs7Bv*kt11)gssF`X@v$2?p=p8HLU%0O^p z0RnwnGLNl9?v3z1g$0s{ykdL5GFtC~QIaeY} zy8EK_@<{wFB_DT*dEYJ#}fu#*fbPNweNCsk2f}ukNbRxE&_)F1n+GoHUqxNot(k&+ZO@wbF5R8k9AQ^q)Go0 z>0L4ezTYCzfjrdGcl2OZYa!_KTMCwYV@bzIwC3maWkWvp9%&>`w|W-P{hyt&mf}IBa>O#2-uozo-^zr|Fn%t5TFCBQ z#jm@$dG(Ip*OG>A3t@(3yHCj*nKGjUpo{a-@lpEDETF;d7u2oZHL-O5B+!P*VPAKvgy+-VZV4%0qTEhAzO!) zNYyspIK=A~I3N?d#}x29%|@PVDV5926YtnK5<9cV^A4bo@?ljTi+u(rRU$t~zOwI*5((ql<`H?r)+aK^>oNbgUPC#U zS0YcDd%pi=1orcF6y#4Q@xC3|n5FZtgdtOwDj zd87_=aPHem^)Wvsfqu_tgCY@iAQJ=o6`<)t8~OTyx#Z;da&Iz^$SDI!-uY*f050k7LR^4&k4yn`ajR`iWa`hw3M5FdMb+!}?zl^j{`mf0w(WWnv- z^qOrTvv4v5d&m#o%E`g*z7{N6xlaQWfsGG}^G$pB&`%fIko?_)Z1`O+gGbd^ z3AA=X>by{VyT}}BazkdZ;O`pr8@_YIu1-OiQ24oH`CjUKRou7y81; z-&G)QIB0adbTv8R_Q6ne4<&awDjW85m~UI_fJ8+)p>B_0EJ&o6FoyYzH_Pys^?n(| z99YlWp{O!OhlF6B4ad-T_W7Ws(*IcN40Cn6=`nwP4zr4QoxdNHvs>*^@+cH_d+N|M zmAS6L798+Nl!?s6-qJ7_UX7Upz9t*flP!216DMOAIl$$wAmkm@AvZD`L1qgA&n8I! z$QI}p8ia$TN%%;P(qW$k+jQ|V^R6RGCWpW~jXYgw4%(9+95g;b=InC9!h{ga)9SF0 zzPU=|!mIN2YhK8iYG03KL4FOtj2||iDb=j2N1%qOvjPE`k83)sHH@m#k_C(>v#shI)JeZvlktaFXX(IDK)5YoP1W73`{2<+Pngo|ti`a+PtsTcTqD*GeYU5h^L$v+CuL*%Gbp~vvgr~n-B)FCS%1N->; z8+t^_1a~ED=?(OFq=kKP1}3JK!LmWDgpFr!@W1}pY^g&pJ@cA*e|9|^AunIkmp3N} z-}}?g_$M8k^rbMajh55jZD42-2)}hYboiT&SLF3doMPm1DRYf^AJ)64#l~0UdFzs2 zes@H=^k8yy@=Xbs-Tvq> zmR#gg^1r_1E~`h2`wjXEnUn5F9?-2beXJKsk$fORvMSkON7X<)TtF{j81KXR_4i<{B1Eut=FphwR#H2o4K6Pwtg(x4z%m(xPqiNBZk`I_0W za{h-B>(|n6_*;vWYtqRoaPM_GS}e9G5i*g^w-H(#-<5&&_Ixg`M#-sOHu!TQ5DR8$ zVfBkV^5imPrA5lX7q(bJZhAS#$?CD>C8v?I-V!O@S6BnP$u+l$gYhGC$)A3=H77an&V8p0-j#x7r^+7qI`# zG6PStOHrv?l>D7)4f9NY_|~N-?oI~!rj?>yS(IFyXNx2A12La0SD$g2*xa8v@_VAl z2-%`aXFuHKd~w2$oV9`Xl_^ThLT!=Q*dLv5X|ZMxpO-cY*G>H*<;WCUyjc~5_D6IW zbUp)PK9}O~r6aQ9kuBa|<@LYA@qb<>9`O7BfBlTrN5vZac6hlAe4To+WlrOim0PS_ zDp^%Dlud4DxTJn&*j_8t@J~^K!86S)W#9?5!6u=;VZaAna`_q6Qw~l)W=OiT*QNET zwB+F~!7hJ>3{2VFV}U{A8(`>o$C6_9R|fN#HHOur0=u1QT-#u?;iI8b{cSGGlc#hW znH-V4aI#rSIqTeHx0bzD-pdoj}Vh*la`(Mqd` z1gSGdD~5mLq;6DIS}^->j2))?+mR<>Cc-Ku_CL47hGuH0Ym-Ohb9rIC1CGv9!)Z0M0mUFYmCeW7H|aS-x81>wnwZzS>rfAU56l^onLFN$2zSZ&+~NXT%^O50eaj?)ZzY9p6$QZBR7f+ zvO$O2U)W>tnO}dW!#O8Ce(>zAWHNI=3i)@^nDbSQ%wuIeocS}GZPa0iFFia*=v}DA ztgq*MhQ}}i+ANb^EqZgl@oau3>lgN97R%^Re8f3%6&(?Ynb_x(g~#_ZG2eoI#(m6@ zCjabIF$;h5Goks*9t4iB^|R^nIhctq2|PFI&Y!iCtYag(6E0+8+44fbau-;6bqRd(XVx@WKPw$krxYccFoN~Ho@X>dm=H8u7!Vwp-_thW>2 zKx^rG%|@!Xv6UEi8yOJUN@~%0kXYSH2F`F2e|xpOCu_B-wT(PZw2?{fWFDop_y*Vs zPTI&@vXFgxIY`^=4l;IHTj_AnS|;vxka?A?q}SEPGP=A{npL)wu6@jKw}ei(m&HqE|x#dOXbuO)-;ZLp>9=A9C_%4jBK)02Rsp*;fb_l;h<4&E?~_lDgBFYL`^p0phqMIUBNbqo6+{;F9C_kF{| zU{Nj{&l`}bDj*9rkM&+}@=?#jkV~IUky|)Uke^Dw#9YOruPwq+cNgm=ufs6OijKO9%zEBU zZZX@4VPqTo1sdTvG!4@(Gw140Dh?ht!kwSTcQRrN&mJbfVqWe+BRn!wxvpZZg@2~K zNkvkADz;3cU$LW+Svy9gu?}405&6fSsd&oI7xH_0kiWV-mATX83VhZZG4ZMqUHG%d zaj&ErV#Kr^M%*YcLGd^j39Fb(dyS67`gs^M%!Eyq>2+G3i~cK3_~&dcuAVnxBLBPR z8~Q06O{kKRi{5K;v3PuF{Sxl~gr zaXJUF-`-lj)wY&Xu;4=48{NxvT24NM! ze%j_9*t&>5#_FDMzUs+*RQe!U6Kpca3v(NIAz0}}w~#02Dlfd6ABJt2VVD-qX9!_9 z)rI%{xiB0V9ELtK!{|x~$E!MF7|D93uXz~8@Oc`L!E@7bWOVwn)=55b%^5O_>HKpw zGox#UVb1}cyZt2dcsdMod-Iv(=ZC)YInLuV#P6NOpa0H<9!Cjdu1pxF^ds}b?;YMN z48Q(Og~bvh(to64g*`dLFnSvK95nDU;!>s&7n12+OrwjXl@Z0`jQF^lS#A%F_)-nbkaA7Eaa6z%?;a)+0_vY>1QE&l1FJQJg%Eijx}dG3>u$cIELHu^>P4XPaJT zor{w;Z{j6og;t{Cw32loK}w&qm!?ykjA^fx!mv2`Q9&oKV|7xUIcBPJTIv5=E7j<7 z{7rtbOFtEc3Hij`_NW~|_o9kkl570ssPMdmbtTp&tMygE>!Tf}m9xXIU#tzDCF97mo_k~Lp<$h{ zT`0MUnRc-JSA~FfDzq}QN7_*Kri5x>-kHut?!8LGG#CoHylZRFh3mhLJD3kTSp(Bz z4L18}u=aHj9U;L;W@{k8Lc(Fu-EqyfTXU{G%t{pR024THghrlX&)Xmi4(0taLw(Ia{ z20bHO|1~*44(JYDC^nTxLN$(w&Ww%a-I3F4xjv)Z5^#ctyC=rJCmP$ufwsE znTQ&gNk0@F+GHAA88dO~8GAwRX2O?y<1@*bs87!EJ9(0q-`Pu%Gx+q&E)j^G3y!-WVO?i;r9n-Q?Qh&TTT|zn1&?YU6 z{D_h3a?anI_;JdJfIH;3Sx0x{{5&R?V?rXwkEZmuhSJX(L;v5CwzBC@C%JE@mfVkO zIl1waFF?NW<(Ad~IY40yLcG-;s0Rdf=fm z-ASkOQ2wo>+)8zndea=`#TzR*VC^X5T06@38k|QPo1ynGb3AsTAG{JXJNfy=2i|C) z^TdLVzBpP$4~XME$-^WCI<_~% zt4K4PNi;_wuhHEKWKgqwFsqL@+LU;s(I6jGxkVT9dmnTsySQB&4$Ycy)Z+U#<1zig zd&2RabBsDR4F}H{@##q#E*Fyr$)uxk7Fot~CIlPk()9U{lOgwRBKN@S;~nTEC-*vv zswp|5%r+9dTq&LX%#dGThHY9iSnes6({oGZb+Q7Fv~(-4_rZIvn`e3WV84pJJcoR+ zy(kP5E^^*H%*@wMWGe%9V|kC=yq2kG>urSj^fVk`CuLzQ`(nnY!H@i4jcX=MviXdb zah$h!AN_2Xhf50_BsrnIoKI28DZRC{3u6z~YNhAp?O3`BO8Como zUi8N5U0&$;%L}%>z46h}7ppfj|9TeluJv3mlbQL=>vFNpZhSRxEx`Nd(IPTMyl-k& zNyFTxX=q9&q(MvaAM;FzcH;ZSHR9Qi%zz`~w5qjM;>f7ye2V8eU%WJbohUc_xYw_1 zkKT>daNE`vXUL@$)pvm65y#iaAk4o`H_?6#QaFaTAe+7V7=5<{QWr#N3z)0wk-?A$vmU!t8i75k+U+;LC8$Xw#5q9&N^mG z4^EUn%)GvOS1*<&dg(}>@VU7fsV3$t{#L`Cb^Hm|1Cdj~PYMjeZv+vjee>C=3c}5Kj z3p-q%9gIsOHMrI<7~`5~fRJE3?HP=%!u~^!>0L{7I60fy(>LPrp+y25yUy|qLkF$A zd`kb|7iMwW+XHhQFfWc7Im=WSZ?g(P9fPsQE*QUaH2>pi{8fRk@eRlQWz19V5|4EY z=^<<#kB#J2x|L-jm7L7RRK9QH=^`W7*nLSh{$Va=B(u2F`El;9!c}W$=9)f{yi6Q< zQ%Mx#Wxces(26Q0PM+`4$^*3;wVl|z(8C@UdO?MbIpKK;aGi?Uznk+qcb!i!84rZGPvF$)(KlfU4Z!aKUi`n6ZM zZo8mxy&0r%T|lnUjZB9BNS&lMq)R$VD-HU_%7<*NTp+(wy|O)alR53o*Y#qb8sp0B z;a05TH48$Q3*;#+gVD>#*TlJc*m?FVl<3j)dpy0XoQF-!$S~t|8Xu1Q5;iHAlgB=+i)G>!>BAa_4_eY?w_}zMrdJz*FP**NaErZupTaQM zCJduvxsP@aM+eSfOEespx3HIpYw%L;RaFDnclUsOK-nf_KF`J1PI;)DOxBy@&z=i; z2x!w;zRhSar^G>OzqXf7=jiL-)<(t-Fh{M}aK}%6AGi;9WNyL<<|*!@b7?jGxi#1i$lpJV<4`L1#R=OvHXcvI z@mD6i*qeu+?6oV)pktkVd@s%Na5BAvXts8d;6$}Fv9ysso^52%s4nvNz8QuU@Z6=d z8CJhkp!sWaJfzq6*EMg{4QAeS)CgQy;tP+8?Afg5i)Y{2=XEa}jg{f3{Vg23_}{Mw zaDKgFgtv|iet9yDZ7#w5Huov(>5P0xhkFKHh{5E$cjcktz&t$Y{uvKnw37v~ZKbMD z8>v3rNw&n;NyFI=@*~F#qxjKBYmOuCCE_|=fh+#zSQ^Xq#%;2vEq(E8yEnX3d{Aeb zFCH%nM|{OFJnkEgwY)}yj)r4#=iM0EpZ$@q)6k|-8uk^C&2P`SbSiV69ZXQ(GQrA7 zPoy0^gxq`VB4?>N(^h6rY%gD?sAZqEjWnvLmd!e~j6bS?AJ3vnBNf}Nev>Vpp(z3}M<_mubP751X@cqaFfobRjN49C%6Ba%JS(5W1~ zjGRk*^<~eeC;Jw@n=qB<3g2h2zmoGt@;DQ2)XGEc-OTR{S4xL_YDu1IBmcxXivLDy zS$mtWqn`rR+7`>m*St2NJnIS|r`yL9L#@0qsizmtk7a)V_q|@fy>Y`Y9G`oIW9o)5 zBqq?s>>G}2<#>Iz8L@)zSs%iK)#Du$b^5D<&lzW{`sKM8C_6c(; zESNLBBT*Kr;-zsMYfRVl;*zA3szG$aUts%v?cet>Idw-i0L)Q(5;adPkvGnvzqiP4#yD_&>PJ(q=)W$eeHziv2L zv^^OL*U8poz*zfwMgQOAUP;pKRia$t__LGa(6J^7GLHMGh&%R3kK~-u#R2|Z)R;_X zt&wNvLph%=U7^9l7OU{$G2M|5=xTgO=X+~r7W1{JPU*0}8C}N)J$g*xoEFZtH^=C9 zt1>ZRHaTjZ$5!BYophxPGi#Z-{v}J@gDkaz{JTRxGuK6r_4512F*!IrLH=2tAiFrH zPJWOeT@P~X%VOTqAo8A^*ISQPdwOcgU(VeWPE7@-MV6-@^fqtn5Kj+dLzgdr% ze9rA-^tfE8!{vMAJ=?LbeG4HS#;!BZk+<<+B+2<1u$fJe1t?EZIz#uLFDbpRtcWgZ)-PTx&$|n%vKV{z4YBUa~RZ z1f4b;%v@LIC|s{`E*rW;;abwo%yk{-^dHCdGNB4*u@ap$;JvdhS1-zH4%nEk#{I8! zE+17PaGe^i$5b%v2}1dp0K}AVFSkR3vK_%Ft+fh@S)8jL=`mqcJeK%yUVqAdvsQZ8 z7PBs`$i{{rS!n8>jXK`h$nKJbr)1x+^-#FhWr8th(6M?*fj(_r?P4AH=! zbJmTntQ!pGeZ+aI_z(L9#_18y9<}&goY(u&H>zUp^y(}O%g=%>=P&1JTm!`_TrZGg z^k(nGo`L_5XDoVbA?2?XihGG0o=y#A&MUoa4!LNhXHKhYvApWe^Sf2UR>)0da&|2o-{VUT_ z-BGSy7>CZ``QZ{N+2@AvHS`-sry}A|F7|wADh-%}ykzij=5B`I-dLWK z)nV?(+~(4~QK4*M{_MUVp{SBg4r?kopb0JH3H@UCo_Qj@To}YP6$`I0f9I^Nw5?qt zi61-=%QNpc3id!f&B4Tg#?q5Hzq#Mt@nd}`?yV>H_fIaWEpH^dW)zC^Sx-zO=UDum z9z$pL><+P#Jwl!_ZWx{N%(LFabL~&Lc&Kh6yUD?=ec+Cr+e2acz_R02<_@>0C&|N^ zRnyiJ{p$1F@JT8&nfdQ6YAW}){gI*qcf41GV%X9Y%xKQ@x(H7Ds z_>a_oG8}JxLa|Rz-&{C(LytysT3^U)ayNXL5sDz*Cr$Q~6Rh4$wucqS{Ok0`IfkHW zZVIXm$;G7U&BXG1p>&z#j<$v5?`9gH*hTN#h88j+k7@3wJz=aLO2;GfyF0Om*}jR) z*jXqkv)!W+@Z^jea)@+G&G9cw9u z@FF?2!yPaDLr{>Ag7d!2*FN4qU!`OGQal7jjhm{;Dku`obRCe)xOkv#8( zXx{&dT-MWCNQ=RLWnzLmKG!54w~z1FKip?8Z6u8w7Ko+79ZnzUhcHjY7xKSr_B9m; z+rRQ=zB}%{qIa);Dvs!K;M%;EG%qNS&J*3x@8K?3bWTN8r(C2AZZ3(YKavx0>Cqq#wBL&CEmrWR} zl>A|363BX$Q+aZBHI3NL=lXZBg`DeJD&NR0_P9#_X=na>o8{u>!UpmWJ&%j(df-fB z)`BiE4|;nJ?k=;I6D@zs`NM7~yA=Wtcjjx?&xLz&Gda)a!h4q|hI9$VqCu(1IQt1F zD_O`KQ;8g{Nk{e}@^rjU4%>09^0%3+C|4r8c>hX2-$(s68)m8(%hY#n_6DUzG?Jj#erl=Wfu2VZ~8YkCIre@oJGa-G{l z@GO&D_7V2g*JvT{?i9+rT5fbLhvL_vRQyA}yX0;wnNYJp8aDO7x|Z}^($n#FLN3f} zG?xi{e=W#gcR9gv=`;Dt=o~z~QCITY{S<99?>9vlj@L`Y)k*Z6@;ZmCE|7A6-EcQM z6h3?CfqnG}E1fMRmE&H+>Tb*&BL90X1%IC9F#o_>`V23YtdDNk&vDX$*KOzX9JKFb zDgUnjBg=+zJggatc?XzZPcFM?L}Rfz|3}6?cE{g2p?Ec({hYPwuc>NnTiIjlON;oG3pn`!s)SGnPZ{)U4MavU%K#vyq;q`sy?bgYp8>tji z93$oWaU1A7$kR0;Ulzdn^@K9!kVJ}iRcm~$%iP-!T0C4yA9NM^%QBOxH=^31Fhh2_=xa+5dtj}P77;~#T z(+4-g4vRNvu>XJ-PA4)@lbl*aNsK()Z-+|{{LrU5xkB=HT@IJwQRQfHZp^&t*Z@4} z!2bB^Qu0Q1dcWWR9ovH9I)Y(qQxkEu6b$U^qQ-7nO0cuagpOrUYO^ zJiU8Lu8muekJCrVpsM7mssw>X94sL>;5)Ju-SUr0V?8-aa(|b$@#lwTpsQ6GcH6|t zr7U_39r-$w$h&>dz_j8r9G*Z9Xqpns>Eo;4pS?T|JV!2NPVvhqX{A#_^Obzu6CI4R zGx5`oT+*OOX|q#_QA3z({6LHGkJ53MUQ53dk#gm}4Xix;k;VMqS0(8@*Dix;ZHz=% z+G70`Ke)Kkdw4t(c@@gI&xnw<%%QHAy%N*DYte2ExxZ>WSNNAanzIeY_V>rRtvYP0 zo{4z=dq0djC=cl$TyZrJjXLTu?PEILSLf>)A1M}rNYUAV@i?zGfMV6 zumNraK<>xldpW)@Gs!(|ij_31Kt4(X++Xp83=e(-W&pYSRA z_-qxf%g@9~g^M=0*_~dk-Q+QO|L8`Ot7;M@^Z9cUCk3JE4=u_nW+K+1434}$Q>!cC z=Me;7@@s=eWH5)K6yLHUq~a-h{pi=5xkig?^)m3yybMd8Mao25Iw4*L!r>3Sgyg^0 zhLRio94To-=+jIKz^IK{EI3F`)}Q=ruPAwT%m%d&25_CD#pLlBxZju0OO-fr@5Uak z$AK`Ci`@1*1G6Ga;oU4+I*<##*(DI3H?*i=&Fm(=&Ku;vek`|znz`*Q$?;7i*B0HW z45OMv2*qFMvBM9^=H&hw@qTDcZnRO9IMKV8Z03hvd@ih}X5iIig{!e@gp3-m#CK&N z*75o3?URWOyq-0`M99Jp^mxu@jV6Kl$h<$lsmsu9E&01!wy5kIfUa8RYp>0K|MfE5 zSsEqFQf)BePaq!f-`lm6{>pb{=wlxvyE@t75byuJ!{V^MN+y11l#=_1mBq|$A5n!l z$PKhG)+Tc^ikxXmlr-<6q|29Cuk*q+M@czn6=LQEp+^OtRkEHEL=N=9 zt7xe=L&?kt`u>LSdB4E?^dV(*AI8f2Li!@#1;M@#eTC+ks6_tPm~}+vGcP;hq(3Z` ztmm}K!0xJCzw4r;4xgiIo&6C$M~ACB(~*CkK312bGH|$xz10ECtI&Zj9+RBQ&^9|l zo{@hX@|K>^W;%F$BiBj)V5Ou8DQl}lT%qMp_ zJsqnTmtk#QtOOrcqF;O<`o_lLX$0R#Jw2ES{Qi9YoZkM}LVmVcwM=|^TZ)crV&$gM z27`A5qDw0sJZogaE}i~d=SVqp*ajy#9?qS}UdIf+PA^_JzoYWWgX7Fne=LjDqVptj zn)KUN`w=7ank(_GdjQN>!%HUj{d^gD+e`d8j!M)#;g1_paY*O$xMfr+4vdVDo2hm% zkP|;$M~m`h8Ns|@`T>Sa*+JvLgrQcx*0ExT59FaI%Zw>*NS(I zczL{DjS2QDW^>V#@L7dEj7kq4>BO52IA@;COME&+f_PDs*bC#wj~{ zc*LmDh4qXbAxc~wtH#;u{J!<9g|`hx8tWMQrUvp}4MG6x(phF2o+|`mJ?qL#9tNQ) z&+%(mFf%YggN(X?sI3pe;Fiq$Sf)YhG!5KrnGHprvHpCXb#Xmm`&)zJ0rdBD3Pf6c z=4;hsUHY^JA8V6YtU})o&!1*D(qP;mW`*n``#6Qab1u(+-Unfdj~)j(-_~oZN8uqI zb~RwuUj}oeyYt*7M~fAA*;8sFtJqhMF^%JhxbPTZfmPT0G|eFYC>WCLL=@o#|X47x{Id z9-*W47^Ka_E3&@LD`%n;>jR!HnaJ9ig`wUV@O0<-%ETgv-|dCw97fVGQf|sVX0w`{0R2ZeA!LXZ8KACzLr}bgX;f#b$bV$SZC)d1C2Fo->zt zA*;SOvXs8K$e*9z+6O}mJyE>L8y?p^ahl)T-~_oVdK(Xue=^_7n#G_nXjvz)>qA#u zd>DM4!=QAbXJ{S0iHCNh%FQs?WwSOPO80zl7@6N%h;T? z534dVRpb=M7KY&>&)Y984a2YpVQBd$41R0LJd&~6TA6uPbD0zQCluo*gyHiuo_~+0 z^RWl_N9R&8sHYJHi;W0+XT-G&Mp*A5lQ1fcwK>)=F4JAnnCIdbQ!)P+{fs=jar%}D zd^4iL6LJf$jj*|9#F*`@{raV%_DLhEgpg?*YsBwrM!b4sgza&<;^va!DoaKAW=2@K z@_gWn5z&Ek8nAZs;4WQs4bl+2+64b0CVcQPVdMcahZ{{$4>w^IS;Y-&Oh_7GLeZUE z%pnU^{w{ebPu90*<>GM-Iy2I9af)XbHLI9#P|g3x^Ll05Jk;EphkAc(`w zg1fU`Q&23W=4RL)#b@MtiS*I)xhg7_m6OV3Yr_(G;?1n~!DcwWhOWoPW+=_)9#_d) zVN@w|G!!W3&HOYzW4(AbGontJMD8z@+@@xjcc%4pXXJ~XpiOd zQiD9>$}mJ;r*~;aI70QIc)v0ft#7eb=M>H?4AwGBnblPx4EagnC}OQ_ZB#ghTn@wa z&pfBS5{8rHF19xd$If;1eg)Bi!P=*Fei*#Vk$oWl@Lw(I*GBqO=acKUr5o2-KoruqC{vW@llEOu8#DrlDOn6?vzGpsjdE59r@_UAFGGTlv&&Fnw1D;FY$V;Ac3^1Xs z56_k8unC|iwLPEDa9gs&=W@|&IDL*}9h(>C;*4b;5^I{^LQW>k(uAz?w+xZd&MsG) zr5fsM<{J7<6NB%Rk1h+oE-?%})w%oA^W$9FSU)$cO=)8oP%+3bzRD=Wf<20q$GfW~ zZ*@?lEV_8!;I#JT#o5gp8Z2+@>K?zjP4^8yBa?e)pEc~QY46fC+{tCdiyg@sN8^&c zzWW-MM{F_dn`+kMZJd+Kl};Cuk5(}zxBI@x#s1(ogZa;Nmm2PI;-b~bK)Ms{tjQ{V z(90&8OdKbS-ae=#@t`@d3&f);Hk##A3<u2Bm!;d7V%tADak?@bm=4cOCil673J;ofpxIIJIQUiMkYzMqMLftl!QPv$U& zXF44->2hFx8P9{dPS1pO7`@-e`1d~3+t0t-@(I1(i?ZOvn&iS{?iH}&E= zacm|I@oQ^rvXJ?K{cOLpup=iE4Wj-Z&shAzQ7&Gvm634{a+AKKezhEAZ**I6P?p2w zmnBl%m-9ugIjp0KMfchaF7Lh2jAL-icg&-7@-_S>rQVI8OC)wA6zT& zhRN0&%{-VDx*!Y+=Wv`So9?oo?BEdA_&?BrOYXw12K~1KFJT~GPkycuUFp?JUYdtq z9FKN2&V#pA9vaaf*)PLhUTEJ!pa{?kqlBs$0>M>`qX zw7ulerFm;dsnl{+;Po~-%Ck!3*~wDz$ne4tGhghai|p_oPxNl)je16Ja*N?e{tgOS1bsiGNnb6P3b=xcUsNCW88s{jNo7hRE{nqm3qLSGM4wA+ml0jUP9PUlNa$K48 z=9*_yWiy`HnBzKKRA##q{BtM{4^uqKA4PwyBa+osbKy{jgogNyr>t9 zg-z&YTpf(*-|H$1@ibk}oTzxzuq7YfjlF)S$rp^y!nktTJon9pfn!-S zjz?)^9_pN7Eq^i{hA+f+zn zujY(C4zMOmKZ^Xt89OyX$;GXhL)TW42Fm&DvE=yQM>r=K^zi2%{*qrjENkkqkbC<} zP06?lX^T;`J#r|a65!?p0(;p?z2RV5kce|UXsz{nZ~B=8f=@Y zL8MnO9$wYsR1W8Z{_$wAL63f%TYk`r(3EB*N2(+}w7DBWM`YI^26ktOUID-Cz(WaC$!4Y}Im-wkR^Xu`f!@-lU& zGIN#u;yu1c)#?Pp{sq~h+jJ$rXYFPaYaI1??r}CAe%08^xla#<1mJG||7Mk+c$|rf zcgW0_r(g3g=b{c~t_{bMOKGKWb(*4Z_0W+|(I{NY`6fyhGs2rp(8`-le6JeCOUt4p z39zS|aWmHsB|Mi}t479QHQL-(W7K%QKV(qbb3Px+dD`(t5H_}>f2&ZB7o3+z$Hn6f z=gG6R^{6$>}zj@>#3~@*LR!9gmhB4{#Umu zVZY?uO?EPFj=glA+eSJkwUsmT+R03wExf9vK&Rg381vU0eS4ZAwyPO_erC@T$Ky`i zPh6!Jv1)U=eV2H`(k&cWM>s!lOg1yny*`5bgGXWbm*er3!D)~|X&A(DxtpUAdtT7b zIx!C^+w;(jW8rghd)rgFR&Ha$_TC+2^y@aV=T>uhxWi6tBJAbTWP2(9UBPT)1%9k3 zl|x<1r27qiUfv8>`}x3das*P&dE+|I3NB}puXbdAz?V?O6^G-JuqWy~GaB?^ICg_v z!>lw^iXulHZ^WA$M%@0$J$6DGHgHY8xOyH|-lXTeCb_gOCS2hCN^BiP?o2}e1k7@jGOJVWPvzS)RPX6!*+!aQS+jcqv&c5uyu?@_v5 z7Ug0)_Yubqk*_@4MxHdVmu|kcQu?l?^j&Tzhq9d{g!8Dmrvf>?e`J$miG;T?gBACc zJ{{@h?@Om|yeF#j<3W-S>RtB1XwF+7gXm}Eyw!>C)3R60p@<;wsiYs0>x@QKFJX3F zBX+4Tp?ELdQ1!^?eK)~j56=V6ny}HF*XXecp@BA1%f?=!%Gt^H8%|P7=&l^fp2Fc~ zSa8Y=wS7ut)PPcHzeItl^LUoj$_wV)W7ZwxgL{#l*sz27+$yq!+z&c0-;MUw>4DA- zhkq1vGVH^#gX@i);5011%RV!!H1;X5pW>$xvGSSsBE4yxGj?cWv4#<6DbpRYhvusQah_QAkSV_Xw0;#z0*)-=pCPs3G*djOWxu**+jqs*PYa5dD6~$bKyd;2wm| zn*<+wbX~;0qJkidt{#lm!#VCWBL{YZZguty^^9TORNHv8JD_KMLPzc*9xaNQWpf}K ztBy0*<~=>NR_yOiVefXf!gbyyg=;lB{h_@R2Gev`^&YDBe4g8v*x_##)*an6h^V;= zjm$Neewuw-+{6+J193?i|TNUw$4jAPbGw zlaq@lYfk1|(?{WY;sf)+A~=tQ)BiU-LB1;Er6gV}-K)}{;G>g(?g^qGGq{4+=s_

n zGkHEeD+}FwWMRr}))K4Hhqx#UVxe%YJ&P{ig&dpLkSE}Ht-MKQ?@f}lwbF|@*Bra9 zu%Kg;6N-ayc4{!@R%2aYn1*}KU^w*&#*DLc zAT5bU);c8pW%=H!L(eQW7 z1DvgJ-MN7M9AoLNyqzc=R66N#nb}#~v)?9@zk99<@=}dk$5f~nsYH05JwofM@#GcP zJAtdvcY82$c<(2vnm}pmNE@XG0U|*{w)cJaIz_ z&$*tGhZ?+%XDUq_$crCE@@%0yzW)lPdz|M!>vEyF%G_$>FWI)&9YX_{Uy?xo;JF-l zS~L-lN_4E(_vHOc?<~)k0*-$~RYiSS`Jq6jSr3Qn#}K6TOGS~Iyv*KK(x-8WEIRH^ zCMFcF^aIY>k^|@2O~i}*QN`Jwh*7c!I3N|1M&{zLQ!|NqQY@Np?x?yU3}eX;9$1`% z?siRNO7#L!wPb#4PACSrkk|X~-}R!dTxPAnME_%&4SR~ar~D5O^|jDiJp28XGirW4 zf?mZf2CQwJgC6AR#`EY53uF71;&rT0jLhj?e3sW?Y6>nk%Ef9$ z3)U`5#DzTF_!lAQ*@L-5*?j%Xryeq(SQgji>+cncZ;w*(V`C2Hudon{_v9=8afh=v zJ(vab(EZLqs9QtX`jt80KRr<^oV=%`p!Mw>)ack$_E#yEZ2sQADxT%9O68vS6Etxx zrQ2U}i&N--Y{J*yirzh5x2GR1rKsW$xtZ^ddV~1$`M&s9WIyoBhVr&nf%vrc#JJ<3 znDr$UV_b9LJlaxjz9S(4nz*em44)>G^seVJ_nkA z8cJTLzf$ifbDZhlJW1YaOKL72*;~rWH>EOtfIDKE(VzGad!KveupUBxU$Z|lkgv0` zmbu=1zb4yr?%L8)HoW{RXO9g>$8Vt+wVn4BzwVoFA^KB=^2ON$H-)diMhYtNe)Ae* zDTi7VOHB)R%=HXGmr&*fd-C67)*YdE->n_shktP7P&dW|3H~cE_xn zp%@aJfV>)0#Zp&k(%$Hw6t_fA6wJa+K%vrwcsL z=0gZJKW3h9^&C`JSjpabMKW}l8$t>~@ZKkt^LP#vzLwHp+;7>imYEApm}$_7Yn=zV z*!Ivy*3$DhslXGBjUi~r=k9&^9OMVLmd{6ji`PLnY$y#yuoL-K2cGF(wvZC~6MyaJ zbCJZnqNfIU@5+Tmj-^!XS;+c?2NsMaha1Qo=Q#RO^IOQOM}H++;Q_nrA*h#QU}i}U zT3ED@Tir_KSF{J5bLnaIPQkp{IaoTnvD8f|lxBTB>GvjA`!fY$VL5PL-%`A#P@a-2 zT-BF3VTx4LJV~GF3M)~NUw$jYp~(!v*<&df_bCVdYg@>C@}d1}dtizUbE5y_D_7>i z^RA_gxbauYHRbaa6av3zDQMJz*V(&;Y)WK}gU`{nFaP;5Q*pCF4o(!-m$mJR1l=aQs@bGO2d3E|XT}`-_ZzXRJ7K$4=UuOxy$Q`MuF_c{MhWhfO_aB)R z;)y1yNLP}Hl+ObgDZ1TXY+)(u8{h&oEk9m37%cjMQmw2zTb)#+zqesSN+S`^I7fTghv+crf@dX5cDvjY(nqr*e4GfKnh z^?Mp2J9gW^da6HueWF{aDqTPi$lqBW5uXAZj!}V_xk!f}C3{o?Rml z-yGTF_&gok>EkP5e(r%`N{oK&kCh*_=-DA189T~wCL=~Vks~uq@rU`jI0Qv9=eMvF z#Y4&Ek$d{KGYEQT9V)cUz=(eI50VG;t8Is_T*rO*$-L<*^ayF`eftz90y$ zT=R}dNk_*9r5Mp8M&94I#gSHl*cHWG)J$@JZ_4QE)yey3N|?w=4Ve~)gv;ru$bZ*_ z7qQZJwGAA|8D;{IrGCGzMyyGRbGHaW*b_ezoT zEkca+omE-ok6LkB#Jx|)ejR;n1ESV+8kKZuuU;^}*tQhww?@c>7dD7o83;PU5i~jjWPAWzC-YD5kesjV{dH}m?ncGHI zWG#8dj}go|uth8Kwx-GC&gj!TVkpB;|0rp|`*XoPe;ggCLv&N-K$VtaR`VD+yuk+7 z_xqzLg3CXFhGumlWl0SsCff51D@=!>*O}A(xD?x*qh!6W5=BSp*E_65)%XmQ zye@@P|0s#zeKmFRz&#=-{FB<%MRT=j2k%I~pZ+=1LUP zOSpzV|4d#6e#Mod%0EZt!gV`DvYvB-yv@u|zVCmS8-65OlqdP`O$)?_b2?nAlz~Ur zOId3rhx^I~j>}o+IjTj6n;9r8DW!WVQlf*D80sE?={2-SanHcgUu8%n-*;N6#9VT_ zRaDI2`uq?T!{}k`6eaz)StE&l)z#DK<-C!Ok>%MhyE#Js1lwYi6&)G{T5Q@!p89DS zdRLB+1&(&8G4ubB_SSz53#G<5dCxi7^f6L+Ke&-7F;86~Rf6HnpZ_}Z z5cM`tU-ev^+*{#>sc)C#%PjKL1{01(Sn=|BtPrBcmJh+GF;#~?QM{g)t@v%nc`U{a zZg0sgHqm2B0PkZYeaU+!Nop-OJiopi(>oZ@X0QpDep;}gcD%f%E~?kn8 z;d0y=KPJdIdpC3$&;QF#hu}2oGsamlX>B4cu-%}kMgE%4d8fJLQY)|*KP*<(Xx;E` za|n)nPC=EW*|@sTiqGUm*9=!;@W$!BV%#SV8`*&}a{$fmp^qxC57(bjSe{S8(Pv;K04N1%C*5&-M;P&Ye-Rc-0 zo=x)dzIes>`mcPWN11g-eZQsWhumhp`U+!+Z=%FHB}>`2)YZ9jNbJtBpYW7HuthK5 zUM9=T**Y0BP$%OLB+0$wsS?JY*P!Rbj4~-=tV#{WLV8NEPTjMsPFjbiNJeeFxO^~3 z)>@rB*_SE@rt4*Vev()oCd>CZ2jwj53LPrD zBk3t?3!Fpue^TP)6Ez~rQ7eFq<9DqZ``6Gv8Y;9LMx93fZo*X7Aj+#?e?pD3TikKr zxe9~JdEh}aYCT4)(X&vET6_7rWDm@q%)jeRPr}h^B=>X2fCsFLzfxg7-}Ax?dRE8t z7z-Gy$WX3Phrc+nbuM)pUxs4;WDUB#=I=k#udurY6IU@d4`kklb8@X=1~j{=$Cea5`|PRpdyVTF z)|yvt&|{~L_2muJ0ANkJ_#^ci^?KH>b!bsY9Yz-eTE5XEi+Q6*jp$<$Wx%e1dZf28 zpu=v)fZsY8nYXCfm~3QSdKEg---55-#P=I;nw(=l15C&Dxap(E+p6?v+MSECoR5cg z&IV5$t)_8q?wt!O>nFi)v$5(kWB2}S6m6%Mpi>U&ouyQL3xuO-pM)sXe zn8V*<%_e(bLf1a@qJD2ex-DO`kTnO^iu}vuz+axn^=Kk^JLBr35=E zrMJRGwx=*RJj_YHH};SxUtMKlO;=H;c}RmV)O}o4BHyc9C3pe7-k$RF^b)E5-Xf>S zF8&)&pXfw-^~G7GQY#B}>TGf5w*pSvEHZYzRc^K`k$-9_kSPkpvPbRdmQwCNOXbFE zGLSVCctXv&i5;l>*i?ac)5td-P~d278@!}e+`bs*A`TTxC~KIt-t&DbD6nNw>UKb zD+7Y?&j9Wrz3EfkfqFd5Uvzp$T{!nZq&E)4=eyK;Eb@nIN7k~}1)-$G9~Za>YelAO zse&wITQZP?Sj&CshmBRZmzxxgp53*Ww3Ruiuk7_dOE27S++UZWMjSb)v1Au_e2<3x z3~~ehT5RR(C*RUyrG>qc>8wk04?Vm!wHxiVD9q4e{7W*8b}{S?qEBvJ>OKZ)IbSdz zz}(SUel)4c_u_FL#k1F}Ewz;Rx-;{%$mQPU{v9p;zDW&%Et&LJ$;9#6WUXx2(_f9; z)bmUv?a##34H-z?n293th!dErKfFB?wbH0B=a7ZjQ!=pWIrA?G8Thy<6N`|Am?l}U z9AW*XkbR4q40yO@;_=l?jC)LO@>)84;xaI6J@<~xv#)X?LphtCxdr5}W{|tmlFxcw zfN!O&)!fU6MX1a8#EfGzsFheu-MC=tE({&( zsh{O4aT{D^(snoT=Qt_zkF#VCZ!Ej)n@Z_G8D`r|PN_Lwb~%e~ zcT@4sah2ZGeoR+2l_$-ciS?&iA`iHU`fw9j7~EXSUviUP0ge*#i{53&$P(VNNQ8Z< zXm*hsj<(8;0;^o^bqnJi5q`Qspe6uME@t}7rfE3WjG??S$J2f6_ zkSXT4nZt3leS8e26w@yvA_iG&$w55VV$6At$A>Z4!S`?QG79VOYcb_hCejB}LvcYS z_KnEI?r`P@M`hp*$C0@WJ;5|&dL76ruFu546J!w+GWi~v$owM{FN?@B-eX_Kt&q#bH-+xTjjUE1#fuZ_bGo71k?nT^iRb{peIl`|fGJJPuN z$Z6y9>3+u1)~Uwwvo*%n^nJ{@s+UVklBD13BpLjXd6(y@lERwNoSyVMqZjla7M-}z z3)0>vRm!lZIT<^mEP!N%RI(_^eRN-*B-z(g@a8^wLAn~hhN&>T zhZ436$P##YV3(g7QHSZ@HPHiyQk1A)q{hHj?oh-kabUCxS8LMOp$2jJnnfyzN27W`suqrDIci)G>U8}*g&l+@m5Q-@q!r&YcjFJXnsLMUz za6hs!Ey8e{Ye9#iFl?B?bz)7{_=ai_RE4@^ed&L8APm35LScJV1LIw4K2{A!%EmBi zvhg*eG>GAvF+;REd1;rdV+O>QxRx-CDb+o+&!3fGdakLmHA zYs_pL15`5%h3mOn{{2eocC<@nUcdl(t;gQ&28{VL7cE%#%ZJ=?0NR*t*0;D@NC$4(m#|u_&Y{=@3 zU&?tdEEC^3=O|myBbf8aIgb0$t_7I&fc*+zsORDDCKac&6VGt9ge#pSc#cx;d9;(w zR_X}nvj3%~4MtwKLEcJRZ2Hp%wWbFEr2!bZkRF*@_M9Y=p}!h{FRfzGqLk~Lr&@SV zAb&oS^YKe99;_rA$6krf%d+r&Dz%D6(?575nYm%~PbLrd#zZ~DhyvJU+0{|dwtzW?mKfq2(4 z5aE908#@Kz6Jy6muB&>GXH4X|O=4W>8L7q7h)g`S<@|d;6RS998-{0Lm}?eJJt)AC zS_K$?H=ml-`FPFi^k`Z>4mh@wP4wSB749MTB3j9jrfntRw}*6_VS`kq0yg_f#R>(c zKC;E;400-DQJ%i%dUYXvGWj`btv|l|(|7tL**rUHdGDbvnU(izGyTEmZpYC>nYjH| zCh8P1R=mt)-Z={%)9F85A)lIioXfeUDrSF&W6O`w)cc6aL2YDg*Ov0dNi6|Qo6Fc; zt>yZ%Hd3Xr4L&_kAcy@&OMI*n-Om<^wmdJ!_BM^!H#CL44Qc!wOHWg-m8%zP*?Z1w z!)r9TTnt7I)WT&Ic|xuq6?uGKBD3g|K_BiM^8CDaja+zbHs>R74L!lR4m?X%ej{1S zm*zGyA+MzjrVjnA&=xY}aWgroQ&BJ5B26YKkTyVpB?GB5`r9Io3%G|ENLGd%$ow+? z2n_SX<=5mH#|Pp0`0WT!XAc6OnH?j!7WZfG13#YFUO)@-lrD~37f&S9NLEIv&O%ak zYP2;kfMq-x&lP0z9mrQYP%ko;EJ1jxoSsaNPHG|gh0)u2?lJa3Qk$`p2U@>SqBXg% zY)=mqy(5d!N&|b&pPx?Am#7x?iI#8=+-L>T#--9fnDz4l17?RCkb9GCb`Jwy^q`kK zKPvv4gL~XJ#$C+Df!FlNTuKgPm%{rCIfs4JN_u;UT7+8_-Y0i67jZsSZvUeb@3VS2 z_3WVR*>^~uT;qPfSdF?Z+z}X{hG%)Qd*7*xm`>)Ld;jZg*n5~4#{4w*^M&la4o`)u zssS+{=q>V#+;-hm_BfLRFU&!o0&>;obAYzF__QGVe|)fYJeQ&m3hxr?NS&Lg@NTkP z;qAq*2RWw5>0SmINS)#pJM~g4kY3NldPyp)hG~&IBFef$|I!`Ho~dDJ;!gi=4c2Fb zQPYc>zYD{0pmjKoz6{4c&eM)tsfXxK#&aX}BKxGG?>*`@j>zR&lf8e-*iYCu8^5-m`tz!sx$FR%V+90Vl#y!^MCp%p@sRV z)1&juSe<;ioGKx+4D$3S*%)4*smImm-i7f#RSgIFZcOV)E``@~LO>5h3i){FmJ6WdpQ~k1ei|4LQR8^BeSZsl=YijyyNUC>JuQl^^h2A{E~2LKWW6 z$(bBR*xGyQPp<)X-l~7~rfErzQtMN9_9e(ZI z(T>`g_w@96T`5VrA~3%b4jq z@Hijic^#ch8D25FH|k+V;=JRfm%-I zwv>5f_I$=s$2X39*lM(V;Pu<4CWF#)Gfe{qq<@tnps!pZScE3eFJT8%yEfv`Kf<1VB z1M$3+x?dv$kbln)^~U-mhS$TNd6aDjxwrEqXBowwwJS03Db7M-qb$TP&qBXWS$H`& z6T`n`A+s5C6HB=ls>i;7G&9Ct=RM=~XHp9JGhaonWdJyFI^;HTU${av`Vop z*EaUYB;Wskyv|HTfS}B>WYF za&O6iKFosGs4U#&wJ{!NO#POLwd`+;OQ0Wj1IG8s1yH=nM_+e7KeY=G>6(t|N8{=c57WagTCk!|$n{5Zw~=gGfMYplVFFvc#=aQ4BFM|(z{ zSgx_{d{epKpdR{8#*Mq=;ZIY~w|*|YOmombg}Kt3AkC?V&>$^E)OFQ3 z!hHMe2JY-*q9%aS9p~%O-+3qJLSCO+oC}+lq384i_UBIs$J_nvPw?P87(fmA`_x1v z8`rKE`==@}enrvi$3U%ivT>_B^IQgVp58$1LDs7~{A)!=#`td@3hyK`guj;@7F}6` zlDuDR+ARu@`LzeXq@GtTZ);YKIz$c^ZTbWbDe;;H*M}6z;G3 z-VMiyd_5)xGnUq)huU`o#6rJDmEAP08$$ z(Yw^$#=Guz#*OFf5xA<8<~33!im@Vks6iUkJtFJL5N=QKz?d=gms-bKrkgw3-Xxo! zLcQT24aUW5$Vh0=vJT@!9}O;6T7lnV*{{GD@n|piYVWCAFphh#1A0`8%0_7oJ~wHM z?_cRzUM?3U19I^05#z&gg}28fY8~_XBnI=mhA6xbBvPA^UW=^7NqnJBy00K>X-yKt z6c2oE<&LKbZfJ6sIy?XHyjHlw=}0)bt_Vd$oe;P)mfda5emxcaxswc-c-w%%^;6OB zu^yFQkg;e;F7|N_e(^p%9hig3tr)x3(NBqAHzmWkpj6@QK(6skW9mhc&2`~D{69Qn z=*ng?kU8-X=OLKQUiGEf8D!neNUiH6^IHFuFehK^TcX9qhMdp(nW>3wC*}Vtk&on1 z&XVtYH9P~cZOoYJYcJN*?Dry%_Gt@`3$`Ll1KKkp8WRsEkW)0dZiZDmYKNYp2u866VZ;ah{5cK z(a!XHeVvZ}qw`R%hO>C)TI8>@{^&cDI(H4pOOijb-fbu~SW9Se%pcmx+>hpH9x zO%iyziY8b-Vj9YVD5erbpw0S-}ZWaS-3%gwq4nCy^X%lm($_9 zClAU4_2txC>RNUVKzElYg#S#(?Y((8KeMrP$h62x`u5IT9gRCH(y_gP8K3SqmQzw9 zOGf*lM+*7M`5E|U1ohFTHIktGaJnDITgvCP>^9<7lt@_ApLkcZkbjQP4ZZnEJq z`O`PlPrOe4%RU2xEqtzKHNTJ-(`k@T(%is$1 zJ*Q^DWbb+svaeV!clE&rj-&gTtU+uxqkm!paXwxm4XIZ+w=d7XX9gM%CI9%czL+K! zOVJ!Z?CTzd%X>31HkH0IzntV);16ltoOzCHjz>PvqiUHE_pGj5D9e1vSwDKIMPp0l zbc9zlW5tZd(s*W(WRR<^QxFY#nSp-g%~;#IzLblgkI^$;pX4ZXo{@p)4f8NVI@am-&#NZP-|J|CY*w1_5a5K;DhdbEkD?*z{;5ftkOgTXpsTHlUvZ zbwxJ@=b_31J1K2$5l=I9E!R@N(j|l3B>llBG?XXpev6WNroFSGa4azct9gB{pQt0< zsi#?+b*G3(a+IFwh+N8^^b1YoN?x)2{h2zLypO9Erc;C3jPi9HGbUE3Ef?sQozyJ=2YYCd{UHPOIgW0(Y9OKAe#vw4uo>i4 z!-MEcUdN1+q4olLww34jE!Qg=zIW+UA8AHOe-}CIPCZciK2M2{#`!-okg=Vda-_S& znu}$6Q~IHwj)Fbsjrbnq1SgUYeepxiQzvvJdBEsu8EC@sa;|v;8Rhhw8bjn3Ymwt? zkbxUq=ika{CL@Zdqf#;mR8L2wA``x~&Dg;F!X*1&lI2fb-9ynh@GS#3znQU1 z^e*H4u;{L{L}vYz#*Vzsm9@BikUa83>WxyX=HjYi8OV9*ts`rCJ{h>>M6Hi4&7|`F zQaL+~zTvi7gimIUUrkS>9u3$>|67{H_;Kw(-ILr5G;7c6On-Un#X?!g>)E=37I!={ zF#2EKUp|K&vWlecRA0oAKkXBdjy%SleoyS>o7y7%!l^S`KN_z8@Hwwwre#5#+?q?h zHs4Uh)zaZBgCzDH=)dH>LC^03nJA%CoN@FAU%yv}ZaqwB*x7=(Hpw!4j*_*FP)ztp{%EQRn|@GV zY-)-qn1iq0J`9t|6KzXpOGL*WXz@ucN8AIGO7=?>MPVzwE@()CUZuU-NKscFo9V^+=NB4Q?2f6O7}D zDJYC){+WKn_PL4DQ>DVQsml@S$Ll#h8~fR_5gnBzZ+5D&n7+mb(}f*zv-V#-YWELqAWh<3hlok=vhME^NoTM&ZzifK!Sh(km7mb>FVC91G@q-?@ z8%^jqkZbOL$!#@u!=|cX7&e=0;(^)Bp;$5fX1v@^QQ^i^`b7Ka;ltzjHll9hz(iTM zpT5tIp@2b$kIdVeY(SGn)VJb#drHSdNo?qb`}AQqmC>U!YY5kVSs;yLrRyG7 zOs1aQeEz?+@6j)qJZ82gR)%#~;@uYdT{WVL;%_G<5 zMb2>|byT~%;dS$1Y195GAJ63qhTaDY&|r9A8bYYum)jfok-J zJraU}CUS6mo^`xm$qf%kF2}p=vHzd@d-vRgUqM#1X^|*SRp}SoHw@{csW18DA*?A@ zR8hrBr&J|coejhCw>o^{IBmJWidW7_GWQ=PhF=Py=C&T@3fZ`~+Cp8IWEtC!{Oo}c z^xsOo)Z_p8cT>l3eTwL3F(1X}E&mn$;(7duE>^@3N|vdqDtP`3!MW!;_NqU`sJY~+ zhf!aZI}u&^(k{b~?qHM@$${S4FIIA<%9Ww0?#sPf&uk3%%ZkStvGQD_gpTj~xCiH}&eSdSR(St>Oy6*m zD+s--2U=5!9(lo-PHuXup9x(iQm1k~YpO!M+MVRn z1~4ZZ$NLiYzvmgfpMNrL_j+aA(xid$;)X*;`~0QpTPklfrnK&4v>sjPHSqgnujqR3 z(`xmMGHyQD`+TPMTh{~kY}0rAT;b&q)-^q=dZgF*+SR(PF1(O7`|TR97JD9^-~Kwz z_+84UcZ?kEnRju@xzmorjMJ{&cy|(YP*IUfs}1wSDXtRB0F4CC6fM9ld0iTXIqN=Ye?9R|jpZZDic{7>x8Y=XMJMtT=F;S()pA+1v&!R%l zu1bW=Qo+2(1C`IH;q{2UgrbJ3whBke@wJE956Yg|er>6_7_G$ldCV_s)wo`u#+(fv z2(-=R4`iY-dXD&zmgNdv`^Lg*Hg6u8h+|fejhQ4z? zX~UX=nRV<{%%QO#_kMlWh8i&LB+-xXy#f8Y>JjKk-Q`bu6f^IiGs%FRzRW58mv{R{ zUoYk=R1OBbWZtR#F6v{b4anMJ!1#8|v8<+MBjZ|YSMrL3vayHxuQcYM{_}%gI6Iqt zoY~N}XDua*dKJvyjc1Le_&z-XnYXX@lOL=<(Z~yxTI66zUN&Z)&qbe3IdIxfZJv6p zS>MP;w-xjn;qQZ%WaF@bV_ZpJuPo-Z&Ss-s1ih?lXXDd1YC_h`##`q9H$<~)5XYtsdDZ7`5^#&;eH)Nm-4;2Jil zbe45c_V2BjVUbQZ*&ljSfx~5}%lP59oY_($lV>O(^!9T-z`SmdMXr)%Y_y1dYr_<{ z5kbF##jl&PO1Vh zb(OwE96{&3qCgo*tF z&?Ag`3VDH;Z6aIsiM|&*0??f7qeB~dGJYd#wIT@1+6Uludp`u-^TUp1{F?QY2x`;a zOz_9BO92?MpZakPVvyg4bzScB@A$KZ@rL=IWz=GvK|RH;)c5Jm9Qh-9@~zWi3BRA4 z$lN(|HRZNzQRxGDstheO{m4E}rMK-OE$oIf&rjXPkhAoPTEN=%T-MW%#=zNuT6D~B z&y9>huU*`OU7$`7Yb8AzX;GE0FP$92eJ1PL-_sFQl#T=MGw_2s@Pb{L_{Ca9UIH~4 zf--U4jowl-+2`*zKXQs~voNG- zCTf3X9xRieJ7=Otau)u&nu%F|@_78)Xy#~cGS5-Gl`NNuc?9M{@;m3l>AV?V&3U-p zj$XFW%(wGrp@YdLE~KwCbMb9Xu)gh@j{%?ZQTGa2EAH<`oT3-*X)=pP^YPQ0?3C$0 z?VJLbSpS*xFLmU~uohK5AHHpw$DhaF8O^9rjsAtVskd>3tQPmm<9D%Eb(1+DuY6n| zN8N(&Ja%_?@w!Tnvk;Yh+u$yVyOmOAT{8*2kEk|D{MRUBF)F^hA5p`OL$7iKnB6D1nVHL2?ZZY}aGUKdr_FIVzVgL4r z`X!Ro(klPyNewI{KU_(HFMY_U6qQQTP>Zx%sKCG|tN0u*mYm@wa%&8A8r#@1PS~IU zeYQfHvc}X-f$Tl(RlUSxHL}vD&?2wsEwja4!FisZF7&<0JY|)BbrjH8O2w9a+S^L} zFeNDv+8Cje(00&wLewI_T7&@R>&3-|fKtpj~4n{r%b4aL5vfp}rVx**3`(4+ut z`^GW2d?;qDBcHs&AHi1wF!&zpl&iIfjflqepcptg#^4*Dd(S@n`OYYe*&mI9`qV|e zrA1{GYls{>mF;3su}TbT-HL|(0lj-VXpvG7jhsR)R=3uoadI^5m}A~{UW*SGSzr6_ zSY&!?TxR}sx)vwHwMZ_Z=gfE305!}-e~LyC$L~4jdA8Qi#OfpTue-_q$&p!DT8$ct zCo^IBL|+r;+SbfU$1~O{>-8b`dz;Kne~vfuiu!@%fjIsg%2U_Wl`IVNMeQ@P(7>0q zJJvW)aXi%-N9LGg=K*uUJ!g_>;0 zT~*eFS2Qj_MUF2Ef4``XV_Ne{8@+Tp{!Y7NevxL=+C5#bXrI=v)c^ck^zyn9QODTt z(_dbZlVa0uoVHJ2)P9H2b?{?P)qsg!?$eUfew1`E#;+V;9Q`TWsO@^excAmHuX(L2 zrANE2H~usIUDt5kGUH`kZ=>O5<8+t#{~GfzWf-Hw4|-aL+NSUQbD!tf$UoB!&B~=m zS<9!#Xnq)%rO;oxfkFQLN?q+rsnVC4C1VZA@+mV>j%=d7;{H^zQnx#8aIz$_FXgbE zK@M!u$(h^KQi{<@@Kl3rUzRApo9U&Z=AcBpO_h^BlEf_~QO2>x(vlk9Cw&rRlA3Ey ztwC0eOp^5t=vzI(AVp^q;)#@{IJ+ z$WUY4Na}*jq_@~-H5PUAfV!;;Y3r0IeC3Xpz38E}L5=ylRB&CbWKWYjDqmFN(_-p) z-%?}aId_cVerv`d`jZ*eC>qY!zEPvbKK9lOVP9g78dbWJeN?kfr(=DNxgLN1?QHKb zsCtEAL8JyXx#rtkIUHMZHE=%~1}AF>`mui3X$o^x7eW!wwPNKbVVKCeUg;3>iMe4I zYz@Puq0|OpKj+8(8r;81-{=KlxaO?E(8y3sHHYE+UJdG;U>z_e4E6Y$rEX*+D~I9L z5e*U^k(X3*y_l&%swEW0PdaQ&V*lzH9S+Y(MeuC)yFAt7RTj1FcXN&BPHpZ9WKQPN z7xWd^hDY^Kmr`qSkO5DYkWW0PM{BMty(iLFI#!Ruy7W5>G2k56f0ITTQ06;((EcH- zQi=NC_6Dp7A|J{8!)n$fk0(%XihuLeWWeUf1`Ogl)YO7~a&@>?TWvzc$Jt14mW%Bb zb8w35y3O1Jf9KjT!HK#s&binal7sq+T;$Bp#<}opOk@tH-7b1>cF)G&G4v`O%bF`| zW^c*EyzE0Q$6@rE=CPKS@b~sP*vPeK)M5H`I+J~@LPm0BHf;G3S(&fr-<~12@_*`R zy+fVl^7U47HC-uNyw!5Jk5Z;JRZ9Cm$mi`X7RR-vGPAT){7JoFM=i*1!-^!C6oJeMmb@O%4$WpUr zaDnqi?pHI0Q4?{~X8PA}AfHx~y2-~~<;_r6c|O!h{u<{dJKi*tqtroe%~<1~r$FY( zQrUV~fzM-Y(A!%9GyB|Ua{U$AF$jGbS9bgkMAj(sd&$(<+C+Yl>ng%Dxb!bI8c%b5 z)0=Z_pDc9py1<_HEI635;1t01#|wHW_sT~L&S~jacrIKY_%9=aZFT4As-zP8cA^8_ zWSzTO#@^+6mT_@-pHjI~LxHX;1qL~hP3fgT;TCFa?G1p}f&gq^6Np}e>7`sL5R+b0 z8~8r;nz~TuiZMoCH3qY`l85IS3J0?oN3*bD@&yzR%ED$(&fAak(cdi}lE^*^@(xF5 zo1x{L>64_AVev}w{NXBpU2HCUR<#tr4E9z$vqTfxGhFSIGW!xWEZ?`3JE1Nz^lJ-QI@Vq4Py^ln zhXT7!(gQoPMAq0V*o#ij&MJZQ!eLxK9Eb~(0&!B~kNEP`N8?)b@@d9jUoDz0WAA~H z{Qp`lB7SGWK7d|&A>{l6GO^)&Cff1qUK{E8#_RFLKOcMPfgSgdOh_j6uFk2%?V4IX z%xEp4)mzAkDE5prRmp&08|?73!KM8Q>?u^h<(3WR`74m13xH;00PLIs;r=85?mzso zaToiMM#TW(F?e;1JwuG+h9g?OC-u$0(ub>*HNrC zWI;Z{_U1$Jglywwy~I%G4}Vg#_s>)btfrHJJ#-STW{&L+y?N)kqiZ{IV8`gyX;00h za^ZNnHw^Fo4#n!F8Z@}4!P|+{sO7xno@9U*_oMYK>{r&OLeD+y)dkeFYLbIieRFY$ zxT*?z_kuj$- z{{m|t1uEQQ%6~omQ2V2VF#K1IO;P_*C2W<=Tu~D(c@@M z>O@|k-)kK68vJ^8Yw|-M$jmeEkothW)BO6^J;oNE&txBRjByI@XXH?8wq;IntHS%T zf!d6@VJ2+ualy80U_~`|0t)8q(RGDr)3=pkN0XJwEd`s#b!IcpQ4{~ z68#1^7yiiP8rm}p1IlLM#{PW7P2#%t7kNF-iD#?Or}sN`uw2{9=dDVKxTuz6R@cj%do~21CFjH_Z|c}r3qXl4nYbVH zzxJYz?)wD>|U~8k*s-2 zX(nn^EI_xvc^>De!_4c{dK|qHF6Kiso%)A8JY+PP!HtZm~tZ&AxzZ>!jm^&CFl z2FtIONYHxjSGgBGScbf5sXuzU(gS-6YrxaV5jt_rF+Bz+xz^bKjXi0#wqr=27_{#Y z!`yf#+^+K@g8rg8?CYvTkB0*05|%MmBr-l!rY}Rk0yvb=n^Kz(=L4>sDci}^`f8c< z+*x|^o~^sjeqO5$){Q3fey&tbIN4x3S)ivg6j(Sf0GW#dal2&z)U5-s%AbDNO@dIa zQw;uKO!pZ>U4Hhnjlaa+H$FeB*mpLH=g~*Q+=(~isUi#W=Vak0a|{W8=A#DpOZ|KE zqb>JdyQoj?*<5=2HkB*yxZWU#@1=8<%A;Il17m24qgCE8rrwYGE#pSm!rY(z0{(n{ zI+FF&aXr?Yxhrz0%bkZ(LyP&GZCch|>GKg3jW#^D=vFcK_aWnGXX<40nv6=w1i0Sl z;?4LzgSBwRtA^#NNqw*Y)jqPfV}TjgE(V#~G+BO{ljPjo6#1>vNnv?K?!{>sJHyVS1b_;=i+@IKABmBq0hyIU3QhBTz1H9ewim|lgH+Q6+W9*70>%E8hX2#El39Qq7(opA2!&t4M zb{e&N&(p7uIo=*Tuf-mzNatMr;TY#YSDpv+w6Tu47!yj3bLLuak)8g;Iq*%O!rPJa z;%w^vMJa5&Te2_Bq@mWqQZn89Qe@?7>h51P$i=VB&rea)-&KtO&V#*_9ym5zjcZ4F z4ld#Jk)(dlGRCstFpM6lK`XCRY#UAApBkx{vz$7*8&lDVabrz$vhQT|ex9L@<$zqM z?_{H%F$Y8MDZKlnQLmN^V`>I98hM?*y0Gs5jr+~v^pdi$j(48iU^?&DPxdSr+;MD$ z2Tr!5j{ihA1nyU1>IoHoZ_r>wk1)i|<~h|2=bnMRXMbyOx&!@=V(Dwtidx5y3~(e* zSdG`G+{&vmWbdL8ZUEysrg`f8-y#HqW*x5+o-D1%}35!20 zi)QKMnSY9$4@r?b)Q=q4llsP6-SN%jjvN;iHm9kvZKgZ^zNo>TkL+z@481p)8V5r5 zls^l;&v-G5bu1g^;0IF2fO&rhXT~wEH|k8x##;7tct*3Q-%1^T4ea}OBRd#MAG*ct zqnM}g{+>x~l={?*^w5jLyHu%t@u1ASM4jwgdO80^Cw+IQaig<4?Cz>@u?%&fr*nUM z%LDVz^IQ%vW{o2c%h(mdz2*q+ZC}5lUN-lR14im`+p0&;AoiOKpk~5GEC1sQmR@aTuY>0rY}xjh^DrBI+;T= zj#F20^5)+%Vjg|5g&M`xGax(7Xb|fl3FL9Qk+WO1nDg1=479IpMu&!u(lWP5Y_9v^ zmYRH`A_I$(KHzJgdZI1-EiUBU`oxo;Iz*kj$$1#sklf;=B3b3)i->?|thO-M*4T_& zzKtZ?u0&o{^2Ot{D7>1N0qwOs?6YYsr#G_pu$2AP)5xPO%EZk8a!(O<((wCt+4Pq$ zHG`uO!Jd5EKh5-@X(&0Je#$oS!+UabjWp@l+tCcwb_ZFc{KfT>9~_yhw`8Sb*R4D} z>rhWT>2rOWI&P!aGdHQ^{nF;)@1O=!pV!UtiVxnOkH(3I)D0~D0K=gAk~ra)1lRY$ zt6(i|Fpu}|aQYf|vXg3~e@G>zAD;32oyfx;BWEl$n zsvY{EyDyuMg?C!d&{Q zQH^9|_Yyg@b_nkL8HElzGoen&gU5^}((6g7+-2Uk|CMOiNG2ww=i$xz`l2pxl^Lv~ z{Kq*~2+zO<9{=WYpy%sX41afVQ!l;k&S2X_U!uy+I#y4JGMfsZ6Wv z4^L|p7Trk4)?wr~-`0}^^KZHG!4L25P`{7kw@FPimL7K!FRoFt5BXv@`QlA()cfQ8 zofO(cEaAnn@zf9$^@_&g@$}I8od;WKD1VnJkx|q|y*)M>O*W?E*o{2aRUKpy`L%UV zsE^r*S{bG3$R0)i`qTDe7)(F(5!7{!V_!cx)6tXp{HUE|b8L~cm`q;pZZy51=r2#6 z@zw77vStK%$v1u&!|^rPEdvFYdB4Uqlxo!R{O7I@8dfG}dNBhw_S`e?c9d;1=o`M& z2iaAagJ+I=d?Dwz6nn|o_d_~N^o7&eD2(dG9032{KXV(%a^-K?N8V)4)-7K z`yX_xFU8st*)qi!>z8U_-#rr^pYx#CG?Ji(#o}S-kEhFcKI_Txk?*$Y(|~&Jh0-Q) zFy>TZZA>z7Ix`Q=$~BSc^M7)T`QmivX!`DEU{@tG=KgFbc~zc`O5yrjR4Pq!hbN#WJzTANCcaal?aNXI-g{!RP-0^;NPK zkvndxMZu+XxbQsJsF>?&QY;JMiwUi$qfm={WkuGUERCd^k@=JRKJXz&*?R?_|Al6} zwrwhpzL&__*F&JAZsV%S^pCE zHf%+Uj@v*hP9BSw0CIe@JVKGv zSBJoMCj2>)y($~Xou#SpmV3f;O8O%Hdj>1PsxVOw;_dO*IZrWMM% z^id5_;!G-a{i^C7BoCqh6Nj|Q2OZv|?%SQdXRy4nmDD@jE@jjD&&Cxm( zZzq@3)Pg^m&zMdAZr;aWL^mN%dN&(20-5V*L%qvkF8CH12K9A%54AL*w=H>}V|zsB ztb+T&V3cd2L;gVeG7EXAGx1{c%M}5;$)Aqb0$VHsvfiF zQ%A1{b^4k@lf}b9i4U`a(eWVpufF6pxJKRAm0lcE z-Pqer?(BdLN9D}F3LYWpqK9>IJ*Rt`rA@$C6iL(C(Ih>=xxWu|fpM56y zU9`X{JxK~otOL>GblyW9PINZm3c0O8r;@}jPl@(Q4X)MIBYpuauwo=@cF3h7@=o_ED<`jx-X!E;bHqS$jYrCXw$awFf$ap6Ob)j5*6nK@SW z^^l{qy5d$ha&tjCbY1fhopQ;yPEC*j=jaRX90vPePQ?u|bHcFs1NA_Q=vzIKIm3@} z@?;hLj*~+%pPXaX=ZEy|qOM=Pcsa6AjgIm3%U(r2M2r ztybjbvMgv`6fcLU$J%oOeXDuh4C750@t!}Qo+y>3sBnwE$y>gX^L=eXEcFCkFT}~| zWO9^qm!k`FdsX>7*W`ZUkJse&e!8Is^+Q9dvfpbxePBGT)bEIsw3TjnwK@dT9CEY-I;HZ zdz0g+_Fif0ufmtrp)mWB3w~w7c#w*BrBK?+-gO^cAcbBkM(6r zDE!*8_Ep6M*Dx!4sS@M`{oI<=4@Jk8df0w8!GYJ|^QdIG_R$sdJh?xjPU1Mu|NS_A zPbb95%F5JpoECzse^bwtM0VkN)p(Em&76 zSqc}b@U3V$+B+EFbd2%hHGSS)lI1G7@7f$+q0B=hd1RyRzW+VX7(C)lT56cZSpL8R z&rAEAyQV!)G>&QKpSJYILr;&dM?Keni|E?gUhn0$x{TL9F^$vfS6yLL-};*Nhihuu zgTqQ=`>d(P37=M`y*fF~%jWJa&yPnxbq2 zWWU$ot=Eld^&*XXWv)03Ujx7F0im3anf`t-2Wm}wAI zo=zgwsd8?IL3X?9WJ<$>Qmz60{`%}_d`;QgOZh$Do+c@Ascn_t}Aoo`3C8*nqTLoNbKnp*-MR|4CfU2L@$OV zH+f9{?TxGMn8f*R{sDI!q26nydh`n1L*1NR?yM`jM!!^syE%y zyPO9a-C-=|I^$onI~mXqp!l^S!AFXQP2qXikXMSMNM0%6l3q@*w z)@_&v>(n>|{~u{*9n|K#wd(}x?gmuw1gU#z*G=6iUUzp_Ak^KEx?@RzQrAGJyCQWr z0@O=^0y+2I-+Xgs&cA2RbSfLd`%7MVp0%!Z-4WF^_!mr;opl6%*1cB-hGPC9I-SYw z|LMaz{Td#Jl?LaJ>5+7X^9hUSQsncaiJKnwfn*u&;xTO>>q0AZ*cQwF@}_u1JFs3g zC?1uz=}^y~{b_zrw}$M!tkH8OMUPXfba;G0i|AcC%wtXc$vs~0tMt%aWX+;8``kME z8F`Oy&6-^OemV@fL!S7l4sVa@P^B_^;_*5hwr9<~BpsHV4UH;hHX!R7iL8xnxXjwz z6J`p2Wi}w|8`*v7%W)#-_%Izq26BFr_rEqfm}kQOudifcS4+-4uuX*FZ8g8ej1hz%b*vCbrZfuferInW|Ds#$66qJ61pB_AA38=_3O?O z@|c-@cFkn@Sw~51?I5rFxXK=Dy66qfBzc{S?3ztKkHJYOD3Uk)`}yIna&k8JqFtQD z@iAwBraQ}qNsdy-zp-{y4(EMhC9_?Z^9K z)`$QM9Khbf0QNlA`ynRF2R$_O$K3YA(}O-(H-s*iVqffk7YNljf6TV_qpO48f5IE) z1Dp?K-T%>K&Jo`5$GOey`R@vVbw6MHU~OiORRBiRpcf*=A2a6qp^@GP`E_jx6j*flsiI> z>M1!Z*9dH_8o^$3Bo4CPFfxYTIb8%&l34E_6oF=(RSauM?vcNo?}nrD5B{uKTa@&Wmy{^ zMZU2Qod{!@f3=Pdf>+Et(9_$#EEq!<#0EMTH@iv40V+B9!&$tpw~+&CcUdvXU8)YY6Q>C(*;3I#E(~#(iu5oJ zd21(~R+Ax~(M+6bs-)a+H|fP(i3a@ImXF9Nk~!&AMTuwgi)9ZP#`S6oH0;2PwQuxX zv{J&>g}ejVlm(7TjHYjKwzF9dyYRZGY!+uaD7M!ukz-$rMf;On#%Tq%@*35TQlM0h z5>0v(%g5?`?d!~tEU!eDuOPx-x>4}Gv|f-iR5 z@WJ8M^q#z>|B(#hd9sHImXUax7>-dXgn zftz?AQePd?Qg_H%pLtPxbOWFxhdaNXL z*U5lvtvvpdAhXzGx}T_(-={be!|$6-xA*wc3G(}Byj-)>O2}6-kJS?7<2EvrR}2M?^D0-Az2yS8LF5m> z?8^RhbpKM}elInSmvDxSzw#cc*)Mg)wJV&R;?KM^gxDg4Z)^M^mu>QAZ@k=nt}9i|6+aNmIm27G-w#gnZy8ktPX@AZvp)zW$4%9KIlzb z&aw37oJzq zJ!142md*LSJgx=LaqUMp$*A+35B^X8?2--I#~YG;~T#=s-7O@*kkkO zYu`Gh$KW4Y6m4Xd-gxFFbYeCM>kftdo(CiJNF?8bM|7z*&cJ@oyEI##0sC{zV&Gcv zp_-0H5ANHV(k;UE;OkH6>}`|fV9)T{an8H4-@9l<23nKLnMKA!*)0=SxHj}O{*P~L zNDga7F|4<64eClyc_ zINclJD%Wo|m40Jd%B(5PW%48iG9Pih^_)47FS#z;roiAs3iv$=QAI3Ec2&tILaa`GW#>_<=S(1snp+DE|qnYIppNGuH%}K&$kEN$vSLj zUgiuX>Mrud*%f|x)7}pXvKKe`Y}j3gF74!Sv^*Y(m?S!=hekr*FcN{anDac(hzjM5 zIQNhBdh!KviM;22G9qXx{m#5sRqn_2LQfNp+{(d%EjgHUhyLSewS?_!CXS`rN!8S5 zGV_{R=6fmeGgE;yDW6pZ^nNwh`{9(yADuQwAm|C} z_@5#XIfu`h&h-3}3-PROM3v1(lw`}%1s>BT3wRk6XqRo4?>!ZmUfmxL_t8JD z;LJ|4FAiSuLuzj_Gxj_1YiuMg@VWME3^|@=WG#E~eJV8x@QZDUs%4_E2-!CodDRm*42S9F`D!1CP+ zuB}RBat*U=)G1N_fl_U(RMDVJL?|;+xaYNIue>6excYh=t-^h4AMRs$Z@OuhiBqioPF&Bra3lH| z$r~u&ai8f-9xg-SX~ml4NPF^nhxz9$h3DUxSlRzVD{Xhg$;T>m2~X8YeihD74pSqj zuPfw@8~${6MO0@shL)&NrXO>Ax`pE8;t=e9u7R^t2v!^+WBFQ#^$oe-UaUjzIQnNN zk$rfmM`snYfuA#Dx(pqNkLjK5#(ivT1|E-6cqZ*oc-CVNLUlpmY44@<sz)l@AtA3=zhx_w8YctXH7CDUW%nJRW z@LWLG--Omm&jDt#gA)~=w-s91+crsB>`RnepXu8QijgUu;^k5xYtLzFj1Ojp=@(br z;d9lW@6TFa4HA}-OBtkrg9~dIe2@N)4@KkIe9p{d4tH}hdkOKV*p#dc8J^9NY52)! zfeqi66Hz>lR?IX_WQ~CDNj$kq+it8O+bccKB#_nnt?+DAStpm`6Q!=RUe3}3_Gg1m z9_`jiu$n$JTUQ)?szMV>7YupiioX+>zj2s8D+djBC25c`A{2xAg+gl=j20pEZB^i0 ze;n%_ZaR2`>QS+FJX-!HYmvj*Zq^xm&d?FOlXZ;h88FZ0xx)Hihh7TLCY$MMtVOpc zKfgQ74V^tPLFiYLU+3b5E&@rPnIuKNYFyc?#*^kee@2kcJ*Gx{ea=;MrynwkYlFS? zF6T4fV|XZ^C84N4MTc6$^r%`s9$8n&6(#GKAsmkr_H+~1BfI05iECfdk=`l;W8Kqv z|519b_)OpE9W$msA%S*U;pw|k;kh@)R+cJVrDhuEH`}QsWJEKudC*iw>q;b=^@Z&N zEs)<ON-jKZCYcG% z#ev@A2Y;O9&qh0m=W#fcvczfDIXY~%K-M57{J$vRrSON<9X}l6{%8b`=f*vMxOJpo zp8J%yd}gJ@Mxp}u_;!yY;Klo6f|Zdx5%=F**H7oOb$K7|33&fG%4fvv_2dO+kfScg zS)rlyBPNjbW@bR?!7Zd~VLN&H!%coY<~=&bRdS4+>-4l_evk!oQn_byR3LjyiRi2Y zFm19wRvq<6JbSV2N7D7zCII!g7s?2v!?HK`H!mYl`7q}p8%N^ReeUOn(&1Z)&f3!S z3fo`8#xkjNJ>>wWv!UdA-o$79GOHZS4o4DR;B6Xcy<>&f3K4j9(f65;l`F?#3@JGd`k^JwBL}MS$kFiz~ zmJ!LmI-mFbQV{J(2mS0+9O63TRe+KAEixSMc`W4KkKHk0-^wx5sZeb0*yTogj-t=JWh{ z?tS>2IO0uTBed;rK1|Mrqjs4#2GR4 zZwd+%c<%6d-=r<)JqNHa&GRQPg`QEK&y&6A)x4z>Uz1LnI_c$;N-x8#5+zC>FXuX{ zP@cZ_XLHo(mQB8UIeQ0Z)HqR#KHs|D8{xfq z%SRo&xTc=jFauQ;anF%!(?P7Cu2y(9B)?dj&y7DJ&*etI+;9sl2)9wYC6L9DBmyTHCkV?IZ_b8Wsl6Vu0%i`&C{ zAz8G~!xf%m_-y?|KhV3Z1Q|wmeqL&#G#L>uhYHyT7?~(tpSWR4mOFlKbcOXFSIn7D z$M94a=r=N}XoCj1%23{~Ll9>l3cFDH=UGplvp|Q=tZBy|(P5(K(RU&1)I6TmtPNl7 z!}q8ZeZDCf=s%yC*ksGAsFa>tc9XHBFY>CD(zE_4GN7y2uee2quup=x-DWm;CH76L zCrN+y3Y>Lrn5lHbfCRb{>|J0y?SiLf4GJSPIBB85+WLHte$sO>QN#N<=ekDfu|I_@ z;|V=Zc8h056J3P9oVkj~Kqwi{r*$&m$Mwfvt~rjrpwolLVeGH;Y{&cb@#%EvJXLr; zoX4Dk%s9FBAYL5kYB0{!i{-UM>A%_)o9DWq9(m7)N>{X6#g zzVsb)e&cOCT#+i5?jmv;;ALq-Cu=gK94u2tgvgzzkyYtxo{9m52<_RlF$o(tBpK;#( zaTrdXOh#=t6IKtXFK+1ta*}&2|NL;?Us5postGc#iOinEoRk}bQ1?A^K$vGbzbSJs zYT0nMiS_ZG^bDS+r_3z{>zbI5;8{lwcP^9At zBN|Iz&qA4W+6QCwtc|rGFTF7fi>Fvi;jo_@YJZY>SR0*@5*e8U>@^?DM0ut>h` z@WzngtoJ=j!He4DhBjGAN!fe})-ca^b~yAttZo0!LLKstBaOesnmIC)Duv^0=@fMA zkcIwD8b~!V=8H7m=rJV>woO^DV|{vD4I8<%;IGKaLFn3zu7FBLDE+f=sHm=#ZShxD z_4S5+J3WSjQkVrzUQE|OtnL4b|Jy;B+c*q(!S_FwJYaGYXdAk!)bUB#7R(+ zo)@+Zq-XF@3LYnsYrEf2vOg5b;r8Bm7e-Ev|K5H#^Qj$e^omjgINc+$o+-wWhRwrJ9e-(`G&{o-NIUyoGp}#2feYD`QQ)u%+A=v z^Fi4_jEz{!Zp%!c(_v_xk%B9~==Z!~E4?{mu$^^?PvK#BpOy@_?k1$UGH;!;{Mnbi zaeP)7qL(qBx10%4rmjS%Gb%^ z=f16hsmrkW4-@pEi(Ck3VAOvsziNS^%4lPRm{vn$U&3OP6nevXdM8_4Bp`OeZ5_?+T?(Gat-r8;(=4^nEWep~vrrGTWy}My?}AIW3GHtQ0Id zX+n#!wZ)elYtbljh2xo-@FWEbJDX55sGd|h!W`jxzOXnDhC4hT*4@qma_h?KN=4Fi zurFTmd~RBhf&iZ9s(Q7h^VGjmVH$I~N066HV7@TdtD*gCNx;N>Io5$W;MU{^)%3JZ z%fd8wJ5inaBiWpHtUNv(Z`rF!2d``A2BKO2SE9)^yUwS#^m7VYzBXZONj(`tUbtl^ zA95vODCYU2>TiN`^?IU+E0A`he6Xx>I5M46P`-2)JRdZY!T0m!-WzY|5}1(`%zUqc zEL`c*K%RXokxCQ1@mEQ&=;{>I=h{e5uCr(0Ux{Nr`&s{RST!Wy9hikP;r4QS?O&-$ zZ}%o%M_pOVxiCKqV`ke({+B%QWlnd_D!z_W3KIGCHDA_~kd_5f|B^RO_X$Iv3(4%8 zXQ7w6v5fclC%qex16>)8`s71P^L>8P&Q^wa7fRV4zIaiFyz`i3bem|x_J(x2a6j=X z&Kv(&`|sdOZ)xu=%skgbEcAu)GRX(YKg03-Z8D;VlUsaOUk(~dWCVFY&FXLj@H`1` zn2j~Z8_VY!3REBmts*yit_JzjYhUo|4|&^cW@BCTL0-mo6TO_KVtM=4 z8wdC~zUBR@%YNoZziA*%$sJFxM?Ud(7}iE4W86pPp_jIj8R~zs&CUmX74$GprdMQw z3BFtENEZF48RTA9z6i(f`Sd0nBp*7Xp3Jr|ix=<12RD=B9+iSY08VV z#!S5yJN0QuBGU8(dcm)D`?hcvXAWk#jK{ZjL(BN{m`Lywa>tjtTt@Ot!}B^{CV5h_G( z3dRPV7K#P*pj9lv{RIc42lQH-A8Xi6~BV+OrxvrGi6jQeSEc*H*bW_rz9sG_9*2IfjP zVMZl6oh<%bw^rQSRyr)|rB0~)Ybl18VNIh-I_p&AgUDO;b5vpKUe;wsYO(tddBd9} z2rND<&zaBLg1H{Gb}|=&Tw(L(W~gyUg!#^Wmo7sizR&Rw)3AnoQ*U#u#Me<_9rL@b z8fa1LHFI50nej`-{M1bInfqAu=hfxx~ow?!ka!%UR)c!JZ{Jy#PJYlw#T8cc^bU0(L=YJ zpVtj%cx@qfHiN#)_GySa&GYJEoVeasAuy1>xrWT@WQ|-~&5YqIweo?i%ZSWi&Tnb4 zp$d6YORk+;AC^ip)cCtTh`HBV+_&YdDPOS=zFGKkq^s$aghdX(_TAL2Z^7l?yVdlS=Vjj0H9j~gI;afFI_B38=ep)Ok zlZFyc&WqEV*}c6A?KTJF%4G71ypGZq@cIosBBpvO)ZV%bJJPkR)jmd}V%Hi zN4yRpuS(AGRv&sTb9f&c7c2U8Ds17uU+Kfw&wY#;{QB>WqvdE-CusgGL;DqRsNI-c z>Hsr5Umg-O{hM~=E_K_;vrkWl?+RK6r`&<1md>v5P!%!;j!b=xz$9ZE`C5KtoOjbq>_So=Zm0{wQ=LYMu z!wp*#U6Ma5@(r<-)P{pTRXzT6wDj1SQr^S%-zvje)dNG{%BGHgUt1(MUv{(8wM@(8 zsiy~c#93XsILu8iDMbnL!G<&NxAaooS|=+)nXmC$Cl&U@OXcM{dAK4@PUPz8p-PZy zUOL&VkCt_!mD6Uu)My?nt3Jd_kLK~xZ4>v)H}taZZmcZ0q?6B~dTDnkR+=y)BfpGR zCY+9!v6J-DDv<0pVx|M8TK~-ND zcr>6Mp-_)%WrVU3f7nAYF+SYrwh(=e|~tD3o7zHJ7a7^5(0N&R%&=57r!( zGuw~7<~Z)_OGAUP`K)4qXYJ6NeV(0qlpVx6&=F<2 zawZn@@2gqsdu@@)nJn^(>}&V;WZmX;1}+6K+u{K4=j>0PIL5!v;_Pf_IzES|V`$5! zl0Vl~MsI5_OPB#C|LjCjM=hi8sl@0yRRPueltHc-DN-kNefZYn5-d!xFehOUQQYA>Sno^s=x_1C9GetCjY}M{-qQc zzo|%C^*2k&_kZ%KLb0@}rhp~)NtZ$t2>N6eMVTV8IHJV7HA~^3D$% zdicTmYXHI=>5h5zpB{Yx4yOe`9q12ty+2yJ`(f}AUtC@4507sF=#=b_@t^!r;O~d1 z{{ArC@YxpY-@Wz)ZG{X|A+|G+!ldN-0zL%-gHY-x*Gq{&p0^(`>M0o{4xUb4+I;x79-NvwnC zu|}VKi>#D^_3(PB2)8%l))*t2&R{Ms8LXz4=#N`NW??LS4KGvC*`D0MT=G+kQ&CBk zipu=|wt?Ozn^dS*(%m?Yj<{1P7^$N(?k}^m8mA(kuVL_Kmi2bB2gg#-wmEx7J~{Nf z(W#i4je-1og>qRCi)_4_X+peHHg;6WM!9UxymmCfr)M_acFD#GPtL4;WhUWMGFRJK zZ;H*vy6>E49hHNj^O$kDDH|@ev$381@SWrZ&aTTr(h}xLKgq_W&2(?vpciRxHafB= zvxjxEMxEGm$jHXeN-CLLsFt1297XG(l5zWOnQQ1I!wvM7?qtoz-9dWYv6rKZ++^`u z2kCj!Nv0ig6xr-7TMOLeXhvf?7+oZ;u8R!m;3{)6U8Ve97pd0FQRa%DS5->P?ph)r>M9WZRe|0a z7C6dly#6ThY6jg}qC~K_0vmG`s7-(AjK<`C1I!Y;rdT|Km1yy$M6|V(*nUch zl&j<%&1RYHRU!e+OXU9je{y+63A2Lesu)lrX9g6@xT<87jS3_kE0Sgd6;QubVr*+> zg3{SoX@x%;&GW-$dQVO9%(=Y99J5M(m|7zMJ8Jl$M|ozLvDTH@+#kwT^lelnV==@Z z_DKOqeNSeQ*IgXHZ($!_*v9z5{X_tKK62*psxJlv`YWgt@_-`t@9AEe&#}(7BsE>rxSaQVtvyE*e z9>#>D)uRaf=}b1bJ~_uB^fFD2L8z2Mgj`}g9agm?k?qHPcdH%fJtQ0kGug#q z{Jy*}Jg>?b*|}tjKhVcDJ(9Cm%xGK3*XHjD#o@3BVJ7v_aJ1QD#2fbgCXS)s^a1;& zb9mkKBq!0B*O-B{e9aaejmWU3TT79O#z*=8&*61gGnMN*BO2!M8cQ@{;lWhQxoboR)(q#(GvW(> ze`g|7#Qs`Q&1|H$%E5#Lp68*g0|qmfeMC0qlNs4Ghu4yAHnxo7{BLg)GRYy1c}EVh zCEbe`v+%l74!jqTcS$nAYg9HG@_W5*kn2b%+xVQUaf=)*`jU+s{CfcTn7;pVkj<|P z$)OLjZZ_tvWZlS@{m%%HR8SG0&(r_}G+BR({YJcFOPz?^@M0Sh#ga{(a)KVUsa2VieZvPyp)=%mElFP@{?=9`oVg+H%l+u_cH%EjQ)wwak9}*Cv(rm$ zv8s^BIox9s<{2k*Iq%ZuE!T{nVx-Z(I7xBTi(`!hN&d+7BD1ebmT1K@H%9z!>R7u? zlsO~mW#lZ)ovZAPS!!kde62ifuaof(39{W%Cvek=vM#eOYjQofRt?|wE|~Ixy}TqB z1Z{Fb6K6Mc^r!EFJ+zA+WI|H8CLFIqZ>|Ab&7ni(sEW*u3##qr+HZpzI~us+K>&S9 zpV?m;@64=P6^1#h&@xOsIhznXJ%4V__~6bb6ktwTjYYY zVe}@FSxBf9g0e{(G=3j~g*Q0g(m;c}ln`uF)7kP=gBAR`Z{>1Pe-Lmzlku0OeUEav)h)jT@E?a9|{BfH|40aaiIYLYdq^eY{U3(^q8 zwc2v72YYr+M*-J@?;O*S(>?>nUYtv5nt{g4$tdklr#p=GuihEx_J-MIBRLbpzVGN- z{GFb!zfN?xkW)PBnu!CYGcj}``H!cp1v5v-df^vRnn~voe?~y@wF^b5NwuvoRLX>O-AmiFD6*{Le)6{2{!_eKZbtc3%+Q< z=g-+2^z$}jCZ@{{wx0q|M>P8&odML3rM? za{ry3Y;Mp}G+aknY_^sCMG9v0l*nf~z^vPuW$s`F?$=dfQ#JBK(e$;=;GD&k0Q}h& zfJwXj(RFqNHn=l$`W%^=nUQeKjD(jL^QPCP!orK|)BCBou`m_evuKq5%J~9+GW>gU zkn54d*|!|lhIlSF&B2GcNfOXAUaVFnl9SQPp?i8sUKlSsuBp*_mpc|#XC~$c71BGn zq5=2&k>ly3)rX?+FZaHI8r&YM0p@6M>LvM$Ejk<=$a|ME9yiXA#o#^3_ES1$f9Gsl z5%-;DX3ccSL^AIS`$zMDis`RWwH&O!=GbglkB5r5R!#-Z> zRMg2rgBmLbF(WgB9w#2#2tFtB_q*aX^F6$yLa^*BS&)~Zxbc8|dN_SfE4k0!uEQ87 zW;*ZUJ&${5LrdlrY+$~?R{COjkGgD`i91Od%zq}E&D=-aPiaC}89^8Bm2{l0 zn2GTYN>3|yrRSlkNrT=CGv z8PT_{(64pFbw^iJT;z(JJhCbE$?NesR*TQB7onk;P-i*Db>l4LbUl*8br{)`PG7Ph zAHDSSosm&rLWhI{@9}-f%Y^ct-Zc})$%3pr#XQqkg=fk*g=ddU@~0;Ht*XUK{AHck zjv=SAHBsiRh?n}z$Xr><70u`;ux~;?^I~Rj+*f1kWHknC*PvzDP^^xjHY|Ykg*JNRC=~hlEvrzSkP!ksU7MdrzWcu&xi8O?nNUBh#C&=q@$xe6ya$HzT*@ojp1 zE7Fa)hkNa)2pmi2-gN<)G|m}~j@U6gEuG;>1v|tD- zZ45wEJ04Sj4<0V$J+OfL^p%mU=|-@=Mi=~8@^USVcw3u(z1w`Q?oP$XAx3QdoPw*) zIe6VG2P3=WpuvM2G<3{`GuQLm46b5q?Ji?Ry2*sf&7^FSyV!hfCYze_nI2y( z?TQj3S8-oAPl?YJ{7|7<0Ls4bL-nu#v|Hte1JC{N*e-(mD$Y&TC*#Sw!J__=7^sNE zVguPu?%zA@;|vz}^Z3WTgqpk_*ZZgV9No>ma%avpW&7k}A@|suSGY*qip|8z+gVEa zI*FmMsXUBxl8s&YUQ{y6_znvEVA$`f4d%cXnVm>b_4Twa|%4FVmq#`?xb7IfAml~alf@?-ZS~G*eCI=Ham-W0w zHl{Dg#gR5S*g@trHpoHjtz0GWv09$}a+Mg?z`C8~IpaVcwVd;q^q%*vuj113suwY|0DvZUqs*<_j-dhMkKH2XS6C6Z~ic& zlMZH_OvUxXWM6ZchnUa#u)4W;Xvul8pV{;$xk+9{cR8NpBvbR9rIoIkOz-R>%g0)v z+CR>7@cF*dS4lUf5^r-$q-HU_PcQvZi_g_W1!r;LkF)Fjklvr4R|IED?7046{io}& z9SB|)iTh5S}>3OD|2kMG&IbtngAJaf?a4L!`9;hbJMQQ94( zt2SRRgMH)4Pmy7s!@TJ%7i0yvq3k$UXt#2{K0=KO-^ep2Xi%>U=hL6@xxu-j($je# znxNsVln$3WlVAM9b#)D{$=k&LcYW?MDif|Z)9FXb!1u3YzmAecd(S*$a@`;5DLh}+ zR(h_TtnfTXpYBoejBke@lRs|~CFRml`Qgqw`i}&;K)zDK)fjct4gY4Uv3Qj$c3QY% z{b(mNvcLqjI z;Y`r%4BXG9-J^^P$m$KCBeqLr@`L2{j&|W}z$Be$dXd?C5+@GlV&!xh z&Ma)B`*1YxgGoFV*5}9Cs!`nD6^5a~xMQQiyZOv6_Sc{dpQmsAf-#S*d#3~Req7R{ zm5(0Tig@%^=$U($jzAt$6RzW{*UH3_A|BgqW-BkD+nCR<*$3&Yg9_E9WIVV7_ab+3iPFFc9P04$1@QRm>i*#~h8)rMnd*-cj!F4|u{JrNw4nc+Y z`{>p*xc=9@e<*-i)1KTDmSxUUP$-`D2t~;qJuXgQ|J6dL9ZN9>D5q-yJ_mdyw^F5yP6L-nR&fUd6PMKHOgdd$Q=sKMk&x*3Bt=v<3lg$<#Y#I?t}o%DN7 z*5fhf147nv-NDc8(sw;JEX}}x(iw2sL-)WU=5g~gE15}mKKafTDezs!dP`(O zIq)e@f}i*x>L}-Azoej50~56Ct?8F7mLtFEU%L{Hb^Yn*>YWA4GPZJndBiKqu{Pa~ zIkw~(olem!H=>c;QT~&y+c;;`oqof^o&8$Q`?G`td<{+=})0aw(YOLH==C zLuoVmpL|>4gFgqDFYLhMbjw0qww+Y5`6op~eDHi@7?u>KAY`WrNx$vn{iq^&*4Y<- zdUM{n1O0A`nIC<%k<1Rv7t4;!Y31?M48&4DPrHVnJ?`N~n|R@ZTqsr2rJo$^DK zMf@DAle=W?y3~tWvd_6#$~^PI9`*oYELnFH{=1Eh_!|Do-FiN7?G=usI;r@2$OMO# z^`!I7V(Hh@2lnO2XU$5+yJug}O>ZscumWm;e9*ZOy=*6vVOP$CP3-$j?fF-N$&;?W z6ONxeuX1;okoCz~cDntOpziE}%nQetYnDANYAkz~{B%;1Asy8Mt7M6k^cFa%8 zvKMbR1MY z^MN{&^R>#xi^3*Sz2QH}@8g5NtWlr4mW%*$ou39bl*nFr(#hT%{?+NexJ90k9Ad0@ zJ+a?k$O?fEB6xo&Q^N?4FIgxv!b*b5B*>ZEeog4TFc8O|74gG|6RlUF!G62qD^?c zsgbx(%9pl(2I244aO^DR>(}J@@W5Ka))YxDz1vTFhQl^C1xU}r!JGCH!k)u~k*wo4 z;Q1Dwf~u^AthK8zn^lD}>YNXPVwrQ{L@(zw6GvyPWbC0LDfA%MxtsR^XCsDrGtVo# zfh=bJ_-BPL%;fJHH>0o9ota+m8p`6udD8rk7j~5nL)G{cOl?4?#YXmLJb0h%<%6qp zcs_?GKtH3W zwUjIG#uu?$=Ghn!hyLe*}9gW<4JOe{O|gBGzC*KvoP7&mbrTW#OaDJwv-J= za69I_k2m4PR$HkQSS;!)%ozDa|K{mrJl$);aE-NWdRinWCVDeJl|B{TXXfa#u-y3& z8Ea>Jm>h)OtF*WhoQ5s7^!xvb6_*o^*d0agiG0wF8;{YwANixQhegZz`i;vqIBlgR z*OP{`P0UdJJ1Bos9DxZTjOW$C?Qj|{H#Ea;?-2=YQ3 z<^>1t3&D72-G6(BP&kN7%GPLm(>RAV>urr&MRVqTXtoL@!1;iJPcZlV*s z6&kcBdoaQ;4Nf*@+*uVZDW9Ftl=9oA|z|ne!3IT8%SjgTI=Qq&XsAl2q8ee;Kr^ zwWwRjyze&5vkr`vo6nswkNM6XGqsp~iMixW6rNN6MoVie=AoAaqsuTY-u+8MbajQN zGxN9ZxbpL=5)9WqI=DCB@dVO$X^NIti=*9aO zrAC!D^gNPh^q#>Sd5sy(?tRw$Br$UT$cXER9JUQiAI_$DZ z!_;&hCwaghT^+EKykXPPIyB0sM|HB9p2cX%>*0v+0pt+L^Y)*ghB~v%uv{J`7u;3Y zKQ0($ZqnPhm9Hb5eVrIhhKv2Gjv?4z7>CVP%)z?O>(us;6jWAW!hm2X`Tl&m`xuVo zf}6aLmN^+tnDvyIBF{OqU4zU{mKk>qQL^|7J)sAKu_Tbb#VO=i1I*CxWiE3cXH4aF z-FG=>^c>P*m{Eexn+{5ehCR1n=BI~f@q+*U!HYA~$|IuTEc-bg=S#j11H$-z=9+OJ z{je0pI^t492;T5KEHf(&vr3!MVCWIC{Y-x%_l^EbwP=4a9kr*@8@nS$TojI&_jW1X z(JyIYkI0kre`(}cCp~e3#nmAEs!pfJbiNKf_4W^9#C0F%4*f8ziv&QI&CxWWAo`<8^)Y&V~i~4c~yTGb91|B z@n$f+wD;*(T^=hRwm2j9{4z|@&=YD*M`@n770D-#uvDWUY#A=|{<&%zulL3Z&%TI} z#f_X{J0%!9|7yu?q@gwW?v0DI@~(k17V>zk)3k6{#_N>Nk(A9bVp`~gR}X^d;i9kh zPC7EFJ3j) z8C#YtLofF4%ma8mR{o!TSTlt}5wqt?e9wROaN5P)lK1Cc zGjv{h-=pU7)rOMKjSOdZ95Jj`zq>d#{dA|GZ5<4I6rVaAI#$ilZBbLhyg}Tf9BaGl}P_2UMss&5V6OCK0I zEG(bgyj>TAdF)Yxp+WM+?wd||n5J*_SXcSC!S{H@qs{CY zkB=AYa`93H9ra9HwjK`%|41^of-zD|9kY6(@^_>E&*vcvBzG#O_ER}Yt!k>iSDdI>N*$9;=RnNfg4iy(wo?gbA%IIP=1w~Go0*4$B=tu zZ~0nldU--zFq^z;U0Zkb?W;zhP6cyAHJX}L%&TS3ySJM4e)cQsy2AOA3${RoE_5>N zDt5v5KWaGrR>6{c`OfcD2A8`%F&48iN15DbdYpi?M&%$MoZ znWDq(08!rQ`Cr}({Q2iRcO7#~^%xPxETdCeG+)HE0{hp|*L4V*z~1y)Ju?Hy zJKv-ypbG!oo=#*wr^EW_Q6p7{>U^!4zd7d+M<*|zLygMmurY#p)W7)}HQ6U;4|{P7 z9cH}IVRj=O=AL40=R`W<$Sz(VoDLy}7{*%98xy(3({wem$K=DB)bk(dnDLoD20mv` z#bwa3myQ6|%Pxd)_LdB!eR=kxYG&X(S;x(+6KVK-o%|&Y@%uB-Yb-M?Ea<;z%ieVl z&h0i}?SDA?)@w81&ga!3_Q3<&rsJ(+23i;#_@8nVzury~Y40L8Pd1i`O0_s!I?Bw7cG9B-b9XZArKPn>4ll761-Zq{^>$+Y z*-1{ncaZ|-DMh|yrnCncteK7Fh^?J$YtU3u);Y+WCr)z8&0Sh8aF}3DzmU5++ zStgfPVwY=)3_hTM_3C1o`&5Akp$f#*Q=m;ukqj!QfHUj1F1JeLO-t^$QWWsL!Cc$} zN-R?riE(PN#E_vXiBcjinQQq`%+4i4)uoOSks5Mboy`)whkm)iWU)T59=)$bI^|fP z%}FJm{P`zQYt3RPE|kCC%-C(`2dnmeu({!f=oD{ktn7z^SANVuVCGY_A2Vjzt9M`> zf4eX4exy60p+DXP(*YDtkDSRH&j0+eV^RR(%dsEvmfnCbzIfNfAA@szu!YRloqXm< z5AZ{+IsOQDp)+WdAL6b3&|VRM)v12?Kct=YTa;@Twr8-ry9mhv!9cePx-RT((O`?Z z?b_UsF*AVO#9(((b{7nGQ8M54zVGoJ-yiV(;Gx@%ILG<7`h2M$L`JY0fh4W*xjESt^N%#_jYd1fPpSTTR8V-pi`f9l%{j&Di{-uxTkakbYpFMF|!{R@YhGl zHm-`o(rCII$!=Y_OI~sUIW7L(%?FU%;{QMLnmj^3`WGXaWqX~uP0KQ|y;c^QJ~m(w z`zVuUWYOB^=*T}`ISc2#3^>l7Fn8E^Vr78Yu}pl@XTs%uCQ3>&abh5OtebT2e`J53 ztdnjzbG7`)8dhV!q@xkT)*5k;J&KhZicmbah~6l=7j<+lRxzU6R3k3!V2>b)oD_d= zR!2H3YS01YV}yZ!ZamM&3Z6YRujr6_K;Ei_kv#`yJI*e|zAJ@@9Y&^M4!sV|*~>SO zm9#8E|9VE$sW4*b1#8L3P)T-qN0~g|R*LpHNYP{V(hoVvszY>4y|nx0G>von^pGJ1HIDEK9%H%lu(h(p<&f%6HzU8`_Kcb_bd5 zsuH_;tmX0hbR9ysYGXUGDpSdla9gQlY%hNu=`3H9UF5z|fw2R~A97}UcMI|ram;kT zr9kh4CK)%#B%``kh|01;9`YWmGQ}jD`Y9lJ72>~*eVV59Pt0In>mRZZbQVph^IOi% zS7Jte)|Yyg%2j4p9;;!7^|eegZ&bNh2apk-qJ-5!1&RilVVRu*6V6n~!Rckv_>@W7 zdomY`_r-A?-CZku5$@=Vh_1}SV&CxURAxDL^F@bE%yzuM-dP)ej9cf26=ebFH;&$o z1%7zhAOPzQ`{Vi^e?0l>i%JXpaqGP|rtM&E^(0^P7(;*KS05}Z@x_I5AAH#yfQ!tH zdvwwdYBlfO!@fvs=!+>D_L+J!d)kj~)HBhTZLdL~TCDjrEzs)+w5dv6Aj5Vmf$D)wKd-LpDI#tJI;cu@@^lL}Y zQ!nzsi^(z`priC3x=ne{I5ptC*B}drCm3+sE|Z=e1D=g#)=gp-y|T<;&oE#cYeGla ztGl;`zvo2OV=CF0ZoKD=2E01V`Pu=Q2%19o7{7Ki>sCEqWMcLX11^51pRq+2RJjJM z2{a(hHw*igF_R+Ni0$uqKYcMG$g2podEKv@Z^Vp!22Wb;Ua+Bmdb1<>>7KfM>4P)RqzAT3NuXL-Ctun4|KbKy8>tF6ui|4sD zv)Y?JDbOZ;+s&)#H!rQ|+3Itq`}YE^=&vNn(mF{pa7&WVl_l?(H+_#jr`*tF>6xyR z8RqnG5pI;l3AzNgNd(c2g=7e>TOBALY3`ssOp=43>&$zZomD?`tMZp2PDje{j zAH7u*9r3cW3R!bi=sdt4J&X>l%{ky1dyLaKzt=;p!uvoKIvlXa&BJzl#yY^7=bI&k z_E@#k9$u#%(3yKf?^`PPS+d8}(h;toIY+}Y%G`wxxcN~9AMPb@mN=r$Wad({|6|e9 z9!H+AhINelMb;Je%}^tQ^^t#?g+ozDCh<);>Q7fAeTf?He{yff{h?f_WT~}@QVAv(m6aQm9RHi#Mzj}oTEwBqxbb(9Ogc4*rr^1 zD%i7akdN(N%!01PJs$US{U+1f=#-D#^SLi++1}(slegp27a};|%kr)nBcoaDcsZ16;n7 zv7V3xd+raSI0F$egFZWJ@_J@P7|C_~aHS7uHM|ftv+ZTB%1M&1JIS8&R>$N1bI^Vj=h!$Uv(cH>-0b7oJcYEU+j?6_Wo zCI>W#yTs@Ca1EAyFhJj)j*zc>UY^K8JMLx1)L^aI!-$79$#G}W)jWf2^-elF{-s~9 zGFirW<~h@&9DRTsV=sH@=hjhbL?{tnL6(1;5`GFZymkI9KPD)!MN0Vh2Af6DbCFTaebg4*3Jz;Vh4X%?$SUe zGIM%Axs(_5Ta_{cjcaOi&dn57&%!n`_=CxWc}$??!j}w#d#b zyFpGqoDAb;7rE1?lh~O$N=b}^d|qQI)(yKkBrhU@4j z0}{BWT>adLA+w6`sn-W|oNYvWRw0&5Vx9I6t=Kox%Bb>GIY%C?&@ojWzo5@9+!6PA zws-KPmx!GB@qG@s(>wx?ZbzU;f*Mh!JS+F*b8;Ykgd6EdIzgt^?oub(VY2v&*$!9 z`YZkNaQ{AQeDpSrj#YScD>uPitMF)6M%I#kEvMlJB_l{D=9?1aJz0=OT+jOsbVS{? zoCmdWf^%<2465aXR_2aSjg5fqOFD))U_{rJp1p0xiC&QZS%Ddil zU6qhQeM$e|1#<1DStn?fhnE5Q$R0taaV^;$`kMYUC_LWqeOgS`p{P{hF)}Y%(zhIv z!WIW*9_JvA(%U={0o6GM`5@QohNn*5K4t-{aj*zr6}@0yQ#O<99TQ+R~VR(SLw zPh`XQMg5kpjdt`91f@uud@?i4CGi_iH+5#JSgq4a`eyD&4zRxD$Nj@7vLN^E@$0S= zYOdoP?B)pc%Z7M`6lVCHoLau*n2#olmGK0S!Nd4}vp2CS(O8#xbWnWB=Z zwe01G$ypAJ?j%Rz97N^ZMdl4s;88UNRy?YZsyusTve$Wm9+irV{>bVPh-AwEe0myy ziA(+PM<$(rz3FAFM2~NU21=esKI_TJ?I9mA$$*wavv7-N=Ol82h8N7i*8GRpBM-OC zh)TzpAxAFFelqv*VSH^{Tx39qN`ev{#G$vHh#v-3^2Ics(?0O^= zAIyTkodIR8TsH=>J}`#o^T|aRJ(#cKg%LZi(anC;2=lT|(qnKJ2|sTuB|-ems;H#> z8(Z1(j@ilmmCRf-VL<)6`*!oAPW_t7vXGuYuTy7!l6;WTR~sv2ZHwONSe zUZe9a{)jHZ*ZD;#Ty2Ca&s_nVI!eFk&ddYqC?hBLkU<@7CD2+W-JO-V;Y{x`vpTnM z&ahyd8SZlCBz*>F11FEb%ARCm#|7f-5zgff2*AJd==c1f!Szbp@Tdo~1x!4PR*S~b za?S^Ey|TE?y3L3zcn-_LZMrOvq_Xz0sR+;8aVE`&c^6#YgZ%k3&p8dw=;gP+PTacc zWY7=2+_g%PCjU6%_EHC^|8PX7b1Lj!uEIyI8?Kktcv532!q2GbC1m~%pVx>`!#!IE zw}r{5dng%lNRLT7`3#!FS#j=#1Jrq#b0!zb%kwa16TRY_$>x*$>PUXM>j2*GYOY<2 z{>SE5HtD3-GaV=8b@C!XFI8%?p6;cW8OJye@F(+yxPHx_rNX@}4ro=O!Y9`V&d{nM zqarY#YuMw-;p7L@2)fHG9`56p^R>82G8S&cM<1E((t+;aoGw?|q;ncF?6H*+$o~)yyN(W<`<=E=ZCMyHn&*kP7-8Dpasm ze_caLt=JzDS_Z{c1dU8$e zoQuAr$eCB+GjSMM%LS|%KVls?j_WA7%KLm@-W_AVmh7P8MTN(W0jUybmnz2w>!riq zB(bf~$w|kfq8O*bD+fmmuHp!T-VVVV9WeD1^OsgKXZk_}A}-Psz|U$=ANJuh)Y!UG zkLGtc-_LW-nIUu`a{n=XtsYx>e%Kw6hv&QVk;XMXKZvzwKb|SF>4xO{@$sC(!;D;h z*A)tn+GHC;>3bOWAVo&>Wq!d-o%~p-lO2Xs$yn`(GqW6V@fCU4ZYs>UtHSqw9k3@d zg3lMO?X@CsD~VhquO~Iv*OpvMmj`kU>y(VC<8|mXifjC7_Wdex9eu*tiEjCLnU#nA zQ}Zz3GdcK!TrbGLE22;kpWq zxhI=^M}?T?DwHo(!KIQ4_C67K{F6?Gugs?USB?2w)rdI6_h&QrJvrnC^0|(#)gk`3 z9-Y`9Q}L`-YeydQ=<{%O2{XBMdFXwKndM|X9nL5`ws|N$4t?W{$ylymRsJ8(m}T8c zS};fGZarUI8Ar}&K6$hqg;;vbLXzhGkm+xI5#W z66-6a@_xQI29q0FQ!f({Im{7W)Kc^XrQ$=MS3dbN-8FjX+S8Lb-$J%dDVMtIy%3ug zg@#`;@No@msApQsm|JBsafBBfS?79OmAN0g3UH@!OR3Hr=ZWMiOZa_)gEE-WSjhFo zQa%L)*xvlL&OVmY;te!vrvSQ(swKm3@Hli5^q`;|zQ8$Osj zBN7Tj2C7#SAls*@T%t#8buVw2H=rLdArr63*G%qEPjZ-VYZL2@WuxeMBv+Mlv=IGP zw~@r=3cNLVq3~%W!rx~wud@K}uC|gp8%pI+H*XwBq=znub!zuQ6dr3PB?n5R9=(uD z9a&GW&stnS0S4$IQ`gc7wc|p#Vd*yXR(ta@v9N*bdL1pHEkw&Crc!ieTS2*<$p{eA9tq!1^rveQ>$`0JCN($ z4*CjN1Dx}z0Aq66$d$66GW<_31Rab-_NGh>dBR-XKN^aE^)m4u?uWsZn9bx)P7~xn z!`n!=s=wr)Jo?}kM8V0EoZV`^{(a5m#iUC<~Itk zB(;TX>R2p|&B>8nBd_-@6YsXLuHLP+sQfBqUzsmPwqf4QI@bMXk|WD$C13dZ*Ix02 zF*p)$w$Z;ilb*P$Ev0lG=j9VUaW#G`?(AU>`1k_+IN3r5HR9_Th55`Vz)vJd~7AX=M+oxAKsX27Kw_*L5zn3%Xf7=ye*0i?L;Y+djeelBJRh(Cx#(mnS_i)NLmmWjP z%6Z1^FDOGKt7i>^%Qr`K&BSp@cUMB;)F?dPb3Fj%6xF%*M)rwp>j2ssLd7P zN-kU3klyHp8F-XbfKfNvNzSBF(bJoGZAlbX6=%TyN&(E9v=nWl64^)I`9SL^*2Xii z+?oF_=T_24!RJ5?A9$^e!i10HQWH2|xum(IWR~zON#7{@VgEXFb|j4a^1#-zc~6;y zv2XA*Fbcgo^M2=Z(si(yX!eoQX{n3i0TXx$It6 zCfbJNh&M#iyP1if9}976a9g>1uUO(9d1FfMRxCY}ftj1h?b6R!_^?dY)aLci>sgRN?a{^c1t_qS#Y>oq?Q?0<=<^%fRNpot!TYjR$HuVS9*7|z6V0&AHgm~Try<#IP01T_o8wwjzh*_eY6awt1L$4L4t zTO2z|{~GxqtBM>1rdMEW|9F{0er@d3a10}N){K4h!{inZM<+<|T5CLf8UpOqBBpjO z?!=Hwnh`HH4d~-LNpD>ibEqqG&hI3>jW+RecROn%uS2kTEWLrB$&t-5;rp8y*&btq z8I42nrl$_Q>oDgxiT=1&39|034GLR_!nUCf5f%4PzZw0Kf0D-}r*oLEKeD41QR}mD zqbIq=AMvuRGxLsvLNU3C7BfP~<0R1McrjK!kbj&~D-^*XpLL$I?vv>stQjX~$Z5Q~ z9EyW{Kg$~A;#yx5jE4_M-wF2U6BmL(F7Xs`YRlJ^0n}LmV@q~5Ah56R%csmAs04#FmslQGY-;6n% zjTz+fu0D;I+!uE6=XHBDREti%Ifqr1KDeC;(t&aW*b;X7~BjI2n4> z7TME6;7ktXp-b+6{f1vW;w3G>7Du*+F$-IZTg!9!Of+HXxL66NcXHYJ5LDlxMMf*; zHPhc0G4+5f*=LKcrzISd{2Z4Zh?RtLJ9ymU{eD`DNtrpQF`7QmA8~StzQ3=$P7YqsGOvR7 zos$W_4a|d{Y7KeKTx*6d3#iw5sEdv$eHFc7oPV~yEXfyR~vgc z_UHY=zqiYr9Q;v9;h`BBFMIdf;`tQLf*<1hwmS!VzMC-9Cqc%OpS4X0L(G~am|y1S z=nC04cuGe0+jd?u$xxAJ4 zLh$g74rhku;9U;=o)&R3X{0^kl9*Rco^*&)4hFhbpx&YV(tHbfTcIcME3cC`*_gK1 z#0FO;@hclO$&=>Jq;L0?Ju*Lsp~RKG%cI#i>2AV) zz7K2X+M|kj7}k_%agUs7SB(i%_8gG5E9`J^Whm&UxsH;Pg3;SWN^lU2QC3*^H)0T$Ov7tq;=o}3By8>>F z;v`?}p`H?kx%~aSy15wGvEsk|u>T*P(c<};^l5|B-Qo`)bThuTOWPTv>NRBC#`KRp z%`^1Xj=QhA*~BfP`JQx}YJ1bGh3!xGS#&);NHyW8{h)>Ftf?rNK{V918E zsR^sn7hK)sz9zC|uVq=SGA#A)+&;Fvopx4l>%J#wP0#a{|4Os0wl1x5-jTB@ar*Rw z8~okJt{9nqH)-3M{wvbclU)z@G_BT3N;>PsXA@-(^9SB6N)(S%DKdR#io~_o$>{1y zVzE#sBex~Wy1Ge{Gllb*8m&0aN|J6{lVsT7B(eE?Kt^XJ%GvJ8ay%eKPXE$M7iKwi zeUu;zb|uM!I?3FFCrj5hT3N?B`LUFEW`8p`V@-o+|85aX@uj_C!`Y;8BhWSGe9Sqfg*> z0<%Dl+2ip|&W83P)2LSAMQ6_Pv!1bUDA{3y0}_5aA|qafltC)=D{w%@IA)Poc0iwS z2TbYci0btnVex=}N7D%O)Za6*`sPWgYFbqtI zfd6Rv8z-otyP(F5kMuMqhNB1neCJR#n!P8l$bHWo_9eQ!Qe*P1aC{F^W6Bj~m2kb8 zJ(wATtJK)T`uB9!=G_-Ee_{vw7Oejq_*0GNtS784WbY!9`O)b*Jj)>$eO-rTnL4cV zq_cwecW2f;URTf`JX(hk{v5eqkH$vUt4^?n??{g$>or~Yb*nime6<5T1wP3*&K}6+ z1N=JwWYlE6q|-Bg-;R3xn@iUNzxSlcdd|M-P`zg|itdqXd`%C}LmkTJ@wGgq51M^| zCwAWFz$_)cG*Q4JPXQMwaqXQ+w9kKw;YF#aJkZ( z2_?QQH_6~yl{lxVgnu?`^VO87^n?zWbR}-?WdGo6g&b?3M1z^EN$;kQpt=%Gd(n~b zf&K7-{_tggcSKkqaNG}#elnx*5&6YNzSz0V4~J8kso0UTj*tCN;Nu5Z71_o0zKBtf zZ*-?$#*Dc~nLe*q&JTB``>1CB&2Atqn-vQ{K!i+q{nfn25npL_imA^I!fkhfCil#^8YWQ z$G}{J%VeokTQxYTivBNikoSn3B>&EC6PP`?A)0$7GLHe#m~euOm74CEG4#1@ARooL ziDDRes^$iyHQ+oyd&(XDbC#cHK)f$&X$8#TtDS{=^danKy?nth16BrP!TT+JKZ~;P zl#JHvSy||Dg!S~1S(sp*g*+!mS>A z1W}x0Ja5DjM>+`T@zJ*^!jtAk*xWKA@<}1io~GOJR3UnHGh#Wv$Bjtl?iLvlLw@ma zMj^KEF=7M1$G+QSw%DhUkwzr4hrcDpUe=y=5;O7+s}4F!%P1$Y*kmh1^v?3R3VFj0 zR-(UeBO7GNbKDU;M z1@>Z>>L|_WXxwbkLH>AZBS}M4@~W4OM6~K4%9b6Z(V_P8YmQ1T9(IyLN##y#LYzu}%N@E-1Hu$2y;>m--4*CF zfzF~+be~3;WXS_^8kyy?V?R9*n@zH{A!mZy(Xli{fgMpwSezs0QoUSyd67fjOcxaI zuOAx~=#@rpIoJ%{Ci!7HbGWvU>z&t+Ua0T@bX!4=qOw2s_3%gW>HyfkWtN!I4^>&C zG^W$Tae_SJEMH{(K^Mn9Us#_Cz=#!oNIm0+w?F-0-Iw2^x*vYFW}eoXKn!O-^*_9) zrsevfRu_Nf+4&)(W&qw*XWl!1&-m4!E**dL<@b*0%KNL3jKZxbtPN$)(u{0kPYuGp zN7G%Wfx~WQqn1RWnJF4x?eb=f<4AxbfEIj zt$j&mCqjcIuJo$j;XTKn7n6O+$cx6g_tDs;AUD}SgLCd0l(f`f;CE(x1ZlAQ8r@eF z%oqtYVAaF_WKkHHw?HQ;xnI}&beZ+ef^s5RUmf#R!ZPVd;r-=jU_Lb&;DrX%xypJU zzxF-vL7xYlL7rv6xw!wiO+7URys1gAX|Mq!i`if7&i`kY#hMCp;e>V6_T(?v>zgn& z3p1bbp5%QUXf!gj(TFjAMX+@$Lf5WESjy}D&Gkauo<>%r8?%haXDn-P#LM@EXl}`S zi5$|a3G_J5=DqltGpwvz{e7Uh1dwa0+^7gK{QD=D@cy!AFEp=FdU~O*=ZvlE(!Fl4NdKiubc+l-mF^a0 zm#)}dE92;aSLx*u$?3<9zthV$Lr+JsyeAvBSlob66HC6y`q&)7Od1tzo-=1uvsUG zkF-*wp;q=rrpoS4NfP!?l6ap?mSq)M=09-`t-4k=WoqT)Z~D3llErPiR@}Gg#Zi+W zVPqc%{iBx_+frl==VYEKb<$u7(OiYrrd#RU^WC?=z+GD{{d+hjW zj{qMPO8%f%+m3dYZz>egAvMz35v$**u;wKF-4E;#y_aXS>g>;qvS&}h0R>_7I?iyw zkP#}FLjRL_%Gtb$PAD~U-*{4mmL(3D)5sCmrqlKPT7}$n2c&Fw#KeEu6*<9q%qR9( zTjYS=TO7$|sW8|>jV8w;aNV4HGjfIxKZL{n5PLwo)d-GOVM}Ll?Lh7xexk_iioOgZfK{J^jf%^7qE5$>~(+@cfA$2ihj1=TRM$tY=t;>F}cpvqQOW zJa&=U(^d3%%C9?fiW$}|nLmA%-tR;`>Llt=*_!=Y{{7eZwMzE6#@Oo-xs`iAr(EWw z@Z8V6;I!wtsQo$@Gn&)2UBsCd_Hogi^Du*Q!3P>HIWQ;nS}yXwat@{e`*r8&R!rbb z?4Rt{jm*W!K6!Mdkx@LxzS%$YR}IKT)3%%~Wl!(?C^{Ms<)M`#5B1(N$2ubygEGlM z@(e!wIvs9P{vXd+Mi$QJcnA6P7x#fTo#jlblbjl6BL%)@SW|^8h`ADHdnu4nti(Dy zC9{9HUwP~g&pbc)f1w*8oIb)+fiTObTe>(JE5qs4tF;Zwi}>rEWEvYY8~9Kbsw8J2 zzmow2%*ljw$U?U21L_ScLRyRw$2^MgGWY{r_b_|0uS)I)+DiAA^b^NA%ds0ya&CZ= zyl8KR@iWNJx32_?MP}$UjdLtlD&$wy0JPKlfem-m&i04n;XrJmlOx%hzUnXBPbs5e z@67!W+49cZH%;1RK!3|DeBmC&a(fn9+#}2QE)yR&(fjN}W{*rrtwiQKzbrysvIZ-Q zRPs>QLC()|lmW%I;_;a-e-h{f4$vT6u?=4$_^ck!XZ;Uy>wG5f<@5bm6rI;w zIX^*We9?p=Sl=*WA!jjiFVRbFYbURIJB!P|9c9B3l{8tek_WkTH+%B$fAd?u%~qoO zCMDvRD{*gKg$(LL4;h`6oelnYZQ+l{+?TehABc(kY}!oRhQ2GANBNj}NQ>!0yb+Cy zTu-XUW+CLR0pk-m!$M}}papph@-mmY7h%E|KD+sx&doQ%u743$P39gY+*$fvaFFAj zne#k_udA=4jOMjcbGu1Sk!c*fS&7$2&0x=KsRv)jn`Qo3;ulD_IOh@4{BX`b5Q~GN zk;u<0$RZk!adaK;j)r=+22&n#jpABXZ+I4t-pRzB6a%I<%7W{9ax$06rg(FmNiuTg zjk(;#TvJ-P@Z94fVIRpAC2-$VrK2R7yU3|zC0xifzJB_fXL<$vHkrZqk^<*mkv%=+ zha3sS^lSw!F{4%BKM#@lBK>%FXK3WetgnFiFl-wfcyNtj!vjoIB}8Ec+>CoR+=sEr=l zM|p^T!t-PGeB9;vvX0k%+~PA~$oj`+6>BZx;P8w$D z#&T&Es4`9=+78Q4Uag#NFatJsG)u zTiMGeZ{Wl%$o6Kb@^7CMS+!4}$@Bh9vU#jId-5FJ<}lx@ ze>n^IK93GM@(s+pUeDJNepBJ0pqrp6U)LUfUQ@>Dq`zm1SOn_D+&e{1&eKY7|uM*E=y6DujACF|J3HfF!TU@nv#s^6ZG`!>#_Zl4qKb* zAzTyIWpK_hlkKryUF~JSq_{(U|ouP5ex1^lph?> z^$1y%NfB_ih``@n)G+rVFGEITQ9nJ7-`8VL3i&1l*X75|P*>_Pi|@yMer7)x(aU&^ zF5y2pS6w$Bns;9M`IBss~nan792>?|jT zk~iO|MC=a*)MX~g@mC^xsRE8$n5S^e4|!Uixu=qko6DSpXZ{%0n~dHv4e~2#@T;x{ zb?0%m&zcFMDPC>BhGVA8`_Z1LjKz2S0~X0 zSxYZJ2N}?$lPvY=B#k$!Sjjab@fgqIA2R9kqO0Aa2tC@; z&qyB4$CB%ou?VY&7NNI)2eF9jEGgGJh+RYG0#xcCetbTDBP)2N1z!hiA_XZ5oGN6U z#ZrN(JgfQmaDD$b0P8!`Wmzi#Q@Gyy@!a!ZEYC!&AG~(=Ip8vU~DtSgZSL`Is zGM!{uRR?;YoaFDHPI9=LO0q6h$jH_TOnj_B)0gBJ+bYm+iAlcZV++K?Sghukr`_l*G3h2&0;EOFaGzeC1!)2az4}8_&c~cDxvw7Cd;yEyl z{Ng~?aJU!R-Gnul>Ri(@IETjdE1BoNX?$%PcaqHwF2ejl2gPY(vRu_ANt1^M<#mlz z@nt?yPj3fw*-nog=iXxy?BTyig&x<)rFpPlcwLQuYcl8l4cCe3YR<)}5!*W%Q)VUO zW_vxVUeu$_U_EyH!`Yz~`S|^J9@dS^$L$4qSnwqeiDr2)dr7XF&zzX63XkW`^a{UF zc$~eh@R+RU^LaC8#CSfs8?Tp@ti{i7d{B1t`LidOe)_IX2#zC9UDpXOhdN@P4IRGy z>4>}>j-@Nr`0<|4X6Fb@c*S}5_w@PX>oCBRvjJyx2r%g2v7gVKF7zLs%EKqtavKKb zL34e=_;iQsnnLC#=v0*GZ_yx(( z*pl(Sk&DH#TqjC%(XSdgc+Nq2*3LtJx+-n>TJHAa^SOo6L;sWP-ZO+#@`9@kg#+1y=^FBh1DG=Oejo@1tLC*K*Ik0Hlcqdu93O1ty0l+WV>t+}43 zDm?0wV@xaJtO7qj?J=!XFu!2y{RDCNMo&XTs_a^l-JMr4#`ECBTJZ##KheOI$#zad{X$nXcobJm1w}=HUHY&W`3GX{OTS*f#o8BI&H6+tZG(X%RoO|2tQ9 z-m{fFv?h16*9W@q}H#oLrwniV`wI>2a}8OHW$UtUvj<^bBY&7p~E9`YFY1* zw2wU9;9_}xeK;14kHVt*oU0-iliItD^k%;89_A)rPKd;VXBjxWuMkm%ZKTdblVlHP zPIN^iToeX4&nU#8ZPs$nuS9$(Ey$q8e~G_%N!numU1q=RQfmf0!Bn(R&hE; zmc*Mn%7qve%v{~#U-F#)t}y<)EE?0l#;^b3+fpj}m&vJ? z%#E!b2{V5Ei?~8mYSC8uH7S$SZoXLfFbbC%Wddo1nC)OC%bAbd!GYeojZugiO)nmK zw-0^WNnrb*l4s?O-33ulmoRrp$GPEl=FsH2NS>EH~ks?Y1n-$KS+E0(W4 zeG%|63PXiiOlJ#l;{$z;_bQ|yfnGWCQ=48hr<;6M#}jQOGyfu|^q2 zj;~r9v7Gu#T!Ot&p^rq`sSH$W#+hk)6;E>CGsna{<)8Ez#?q^}p#YyAScxBf6pN$1 z*`H*N!Vm-I-7bW4WgGcoS1MzJd{8qc3fm56Ah|AU_9{!}4Y8hG?2XzNqA<8aCJe0m z_qb#yRVSCok5F&?%ll{=d0r2HdP^s@5!aA1aVB4Om3ht2^cko%s{m1}TgyX>V%bLy z*Pr#@wM#QG!iCNQk2a#PDwRj)ePA^|5*PZCALR9~-qlpJXN#q3Fmdo~q zJ{V7jh0nVTEb7Voh&<*~t1{V?47llqe*AY0;(gbU_v6+9?WEz-U!pngg?oYA368#gc62i@6fTT6`v& z@cqe)w2(jlDi$9*Z=Aod6}`@7Ku^whXE6IHr}#YS?Sq7VQLq`Cfo0BrA58iR!60M&!_Mc+G&mmW7ycv6Yn7E)%O2eBNH7w~;*Z zEOOKBUenjv^QQzyd7|IKNQA7&K%0~TlniVyr&|A(lV;?^`8<5hGs5UPMy$MSA=FA>L@YAPUbyGca^4-_J%?(j&E4mbCI@?nx9~j=cVBl8+wWPX0Jm zEMOWrr*DaN8S>Oqif$L6BK9?#LBHPqf`i%J{$ESK?k9QOj-ROxwQGlsGV`Tar z8(e-Lg24J(yzarw8FEYucEvEy$PRNxgu<-_-9MFb;j+Vo^q5#dku9^QLy^6o9=Fcy zZAY81{z{_UVjgH$yHGq|L_gP=90WyIpzp7Jbh_IjjI-}~oydRrX5+gn^P{u&%Z{41 zc+;HzzOh;?ADM%%Jxwq)jFB7#lpvZ8hPXxTV75>D^eV9A^)YFZ9G&Xz?U2 z8?I|jSZo(7eUfa^u4yRh*^rBwk&RBjD^TV8ez||#7K{Gi>m08|#E2Z2tW4K^p25P|Ja~pRT!oQYq8lxPvUVClv@%df1Cp>`1&s;Yhkiy zKJRQ3ec|M@W|DVvWBvP>7L}aoI;x@Y__d9^+jQo%k}Gt1!hGa&Ik5S}oYr?SvgmKt z^Ir$!b6+hs?aD!ybtZJLaX`xY*&=gJC>&>M(VXvFoEhg_{-z($oIbuZ@?0ymm>y=;w`8`~^Fl=R#+-XDUd{M^f|`T15- zc+4fwc<&TN zF{D$Xq&>95@qTJFHRpA8AP4pICS05nD`|xw_>z7I5h{J9^5nDOq8s+_Sp43 z6wQ6L&~GQ-x4MEXK#a8BYLAlNOW>r?VRSdv>Z>wG_)ff39qYiHw{Z6Vv?yE1S)Vs1 z=z1TJ$!~1Yk-XlYWm+`kbw1|431{xdOYs>Sj3cjCi|_xA*lcuYqwuKwGeNGGS)tOx zFnk)W`!8?%XHyeCMaPS})E4W>sXa?$F7tpKyxGe8>u{Wm>0pa()?s*dPm6uz1alr% zVB?$vvh$=JM%D~P#Fr#=_?iPvV|p9=B*;x(Z}sQXXZMrYqEEA-nOT7omhn>kfHgd7 zgre_iE&fQz#>`|B1`dpuZ#UXwem-;67w9mxe=c_1rMI+woE+_GhmYiZ&7H|D=Fq1} z|J~Q;^c!Z_qAIhv*`D5+~93cQ{4{&9KD?a)JTmK;7w2O#in6t*~FFc-mouZz%4^lB+$Ci%py8 zOPw4q#?$250{D6TN<#U*Y?%F`=dn|QbT+fa(25YaR@cIH)c<^uS>I#i{!BY~`-Pwr zpEIu(vG-C_;Sqd2MwTX7qjXXzs`9#8`&SOu7gs>HD^@C9vqjyxAsAJIvv3Axug+wy z_tFG;>T8WTe4bcV=j-pyY}BW`Urxoy=QKNHFju;BIdi>vogb{F@YwIo8R?bQ%&rN= zxOe2KopUgDe+3#^BuLO&8vf!DjJ888`OO!B zIxMWlK9f0p_1ak3pKk*X^I)u=OFlF>2dRAitUAFw^mH4nTojHVOLCEebMU^M!oxC( z&zUpKa9bZnCR&S$d_6mQIw&u!4i1*TQ#74zofym6ZQj$v2RvNq+rbzWqiUUE^NK7ZcXv!fE@Mdgw#;dJe6*p(<#vUKu`?|JA0 zt@OXftU%`M9Nfz~dkd{p<+J5bZ+Zj{B+CWXbzSf3WZFN;;@V3q({JizZj%&w(wQ}c z>&bG{Hc7fhCrUqaW;#vaoa>4N`4q2{R9@Gc$WC5en<&#VQe~u9swg?`DvCI{SRox0s62VA04xh@lM`^jWYq43tD)doEr z>*_fNp~H>JdemqAtb5~RT%SR|&U!i6J<8x>cGow?JF^gZn$${%#Up-#kW6z-x z|LiUDi+l!e4Ax;6``M>i^J>mIPI#^!D%Rf2*XdBNrXKx2>F_N_hv6FLU+^__)#~uX zH4mws^N{;1AJme=F+o#F&7EXSeLiu9P&)EiSy}WNMvTmH*$#jJgo7~ zML26zHw?L`@gWztZ1NG^IG@?}tmm`m-PFVx3_~8?vSu@VYaV;C%$Qc?V(7_S{MeI+ z0`|WrHOWWcZg~hR$weCLOB*LL`)!$vczSh^CWQ_%Xp6O!SGSXPSDZyR&{^IewwH`v zE)sjtN{+p@5!>sWm;Y!Z!;%~X8Ifd08je$d|-SD?TM8`h2^%rMMKi8Rh3S(LGcJE%g6 z)yzHgrQaY*fn)r$dkrReTv{##MJCaBv1c)}LIyjVq__$*t0$IAj~E5dzDiu=-%+_# zfoVOI=seXVw^Mwfb@D;~;mp|>Qs+QS-bI#i5wkb;2IBcT zI*ls)FuJ8bG~4`9y4(l*Hqj9=(;t=I_+w0@AJ(wfJ&*kXGxl}Mu190xDh;|^j7Iw> ztdHL%r?`PRxl_q8zGbdaWHg4Ec- zANFaGH?!gJmpK0z zNQN=IPZrFt8t@|BfW}3veO1cD?Y0J3tTAx!O-GVvCJq#4(cwiOq=~!(zfVGCdL9i1 zD8{mvO%}5GNcNAd*h8OX#5~sg>rNz#=*QkZnDKXfF8LuMif`D z-?Y|D|~?sx@IgyBQrKi5;Z-4F{Q3&0a<(rLDL% z`z>F(nW6O9GOSSc-vL>jEGiSeL`#uGlwNPN4nG$xBDrDGm1yT}BQqo3&8+%PM zW4Iao9V+By7X|k3Rp9V$vJfZ8JG!$cNJb)=_nl|90u5HNmy)W$uSq6R%`205Ka)Hf zYm#q0$wWHR?RdL_xsK&B_+6RYX6AZ9JwJ@h_r=5iL)u%nMcKV!+XHrY5Q>P@5O#x} z2X^1Y0JhlOEopZFV`8Ah%m8*X45+u=l-&h`o#ed7{d=}|dp^MPhZ~46jMvOs*IMh` z&;3}dLN|IEU)J|Wlj`IWhp8~JfS*L}d~M>-937-aR6k}_&m!+opZU{UqOqoPG&%*UG4Bq0bH|V~ z9u|$lDP(+#nDxQmSG9^7-7UzFsOV;N;>Q6Q^qyVB_V>)H@=so+Wb(72csg z@qRk))nPU(YjVpX)6k(~I=08Bqc!VuBbKLQU=5x_#q(^e9rMC$GZ2};+>HffkdKiq zCf|7b7kLzpso?o^TD4Ed!p`K1_`MINlb_i{W|B48+8n2US7cyCB)zK-@-c|-{rdKw zVBWp}W4(-6evi59W=5zt^L#a;0OQ<@@a|rK9#sl3fa5Irni2Xqj-51qoKt`@%L3H$ z;2(~yJ-J2%?aRmD+jO#=W*ze#&j`EdD}KGt2%ZBu z(777GT>0*|yV$tBx=@h)yzA@=yY!LMPU*Y#i}nmnov3de;-h~&=}_te+hkAI4l2)@ zVGB~LG>h^mdix@^-KkU$&!$y9R{grHuit!{=ak`mmS2Q(PVW!d2Tm zr#@ibvq!SnE!WAYZCVMsnk0)7H8MXoDzWa03o4Q`{J5K$&)?`*v~$5?_GzBJ zt;BDg3j*fTzs&mzYyxPZgXCC`zxMnokALphHtGO;5HBE>4YqgmAj}~b<4YRq(G?Hzsr%Zx*E%vs! z>(Ga5L&bjbkRCc*iqavay$)Awbo9{j9Et0|YUa6kJ}et^N9JH?a1PR^WuZjP-rHh& zvRJPidz<^Qw)C1!$iW)_Y{Y1o1-g?xsZH1?!*ykkLaz6Q(bGsSX8T3D(CYGhFp}#= zaznpz$vKA5cf&fYjVcFT54h*!f*bf4PD z*!nKgLAjjT)SPw5*#?YruS7O*$DydM5gk$9_?OXwC@-IiFPJ z91{QCi0ZS9XrgW>JyyENd>0p~RohJ#opzPQjp#>=;aYFMImVI)DSy}u;hqYN)sRP9 z>5q1H{`jT{q*FNnUA_G=+`}JF$e(>nqEC-=b;c-iD(jgU6|aWp-gKxqe`aT#T3g`_o;@f7rr>}D^=5;#VkJ*!n zE#=fQSLqhwBx@@&FMMDdNqJvNCp7zh7SY)>)eO^{nDgx34C6H_U~nKKF6oOr?T3a{ z{1KAui)UeK#PRpL^4b(Bcc8`w`mXLqq1|`#f_y%`r)5Cr&2`r;KEEHl2bmSXZX#Wp zbLh`aB!fDZb2YEg&EZZm^+h{Lhj!1v4^AnFVWx-Q~;V{SF1n zP%6ov*^kiHAOB{maI1bG2BrHWF@t~Sn$+@ZG)DH|y|)GX2>AEUyU7&&HDK^H0}}Y& zSvfER^WS8k?^}M}`V)>UDnK}`?^Kpbd zk99_+$QjnohpLk09eW!8lrf8;whO**C3BJQijiMk@u@F+3j4U=M@~3yB{1_PCLG3v z5oq{4oLnmV0N1m2&bcRr^U7I%zSWL<*uhDt#C_k&Q5^IAb8%`Wb17$V&e)xUf8)qI zkSDm=jgH2z3a@YELhA8rk>v5C@6#=O>zK4@sFRM}lI7)Pogjd{kK`}5dXkIls>H)x zWG~9oMXYC@eC6=6eD!qT%oWoNim`$m}JnpG&59BpdIg-o%q~F@&1%XCjT3~ z!Q>t?dGB&B3&m$%pJ@-tTMQ)A-ZKfIw{@sv(BbiLDfq#D0kR-U-d`^c;=S(!J;WdBw&MLLv504yN_sBd z(Ql>AK||hmCi2=ebmcv0RW{;+6<#l%E4=)(6kd7P$fxkEeKC2$qJdhOS20Q4#~hVq zlaGkiDV_X0oG9z7lO?L+3j0gU?Bw}Vw};FS<@M=2fG%bCaM+#Ty?JsN9tALa77>VU zLU(3EEdqH)v(hyQmaB9qc*OkIOSxDufqeeD94t!W{Y{^Pm+!ODXtKg<+#vEzWJ1>4 zntA#4W$rY2%Wd@LejaQuTi3UhNn_mPhSEizJW|SYy65+;Hpe~oU_IvjVtgM3ylR%p ztT@g!LH>we7>HpO{%EwE{MTfEICkMW|6Vi#Ox#uN-p>JlS){y|TlM z)?)X>Rh%u|IjOioys<5RjXrqu{QUTFX- z-}A%D@&4%e$`4KEvNwxo2V=ErW@qg{`**y*b3R--f%75fzz450F#8Fek%Q@9&Q6EL zsRA6W#d)yBf4u?BNZ?+&_#E?$qn*W`{NlnX?y}>nv$VBiPi)Ul@(5-as4A67;R>8? zXp)k}W~lO-ds)9g?BJQo===Vd8WVu33;p2Nk@IwUHOj2j__CCHuSJ}f`|ZG|Z&9%K zvWFQ{8}m%xZapUpXEL;=9*4XF}s|5POg9IRpVKZzY4h> z)i_#*+~5c98HdyJ8OM7o_nS{k3{Z|_7B^orhr{fh;CiFp_cY|+Ex>Un@|D~hy;#b7 zDbF%4j$}W_J{R#YqZ4{*Ysq`tT&_2El}A1<5-`&Yu9eH-!4q@5sH?!$Dhj+gSth*) z@a#$F4|}^nwCbUPVU3FU&jGOZj%MF2`|o(2QrR2Of%mV;*n#jX+#~8UFd;SroxC&f zF(m`NUNdu&uhqqMbRDaiThW&Hu2sf=L-FBkg!8!^I?q0FuBV@M&B5_nxtK9j;nmqv z;WgJ+;bqDB(7gw1=AkNMv#D_a$WHt7_P33;cDIDorBCvBlug~Rh{GJ#NS(7sJYL~=*09%Du*#?D|{xxgz z-xOZMxkoOJ(@1lpR&MgzY+kLEbIUYRvYR!DJuX=N-37TXxzC*ELYE+2mVCc7;e8@u zM;Jc1MPP&>9JRkPgV3Jm_SJOQ-z*77lXX~AJqfdRai7*C2eCXKzx0dzLVcD$Dzq7!;CYlM71KPLk_yB(j)ScO*xKmY%EMvuwOWEXiW z4S71Rn~~@}!hq_N^I>LeBKwwc#We4v*+Bv#^zI1!YoUyD!fZqVV%`8V2g}Q0u<6;Czt`X;1Et+|9z9Y3TXw zBl^v-kV|j=NXaN~RDH=DVe)rQEAmkNfsIrjQ!F;Kym{}BLM%C^0ewEA`6oWlgd$l@ zzU=CRD3rEi{%qfTEL+q>HZLud#(CZt{W=N<$EV@Y;g9&YcN0k*TOy+;`vG5~cz(vL zk;8fHW44ry)eEHtIiLzUdg68(xE9RE^%!fh*8CN>LO+;gk{`UsoZNGHI6JU~_;xFj z?ujZm|A@l%)6Dh0%G{94*FM4j~b*n>8&_EAnGaDH;wn$varGESxg%2kT zxc-!$z8=ogQiB)@56Aq5M6OO3`pTwg_@|5E0;jL1h|clrva7fI+?Uo5P{{Ni&4 zyt86n_S)u>FtbR~zxkqc1G&puysvfVy|m0io{_`dK@PED0Qs+q2Chfh@0?~W4|oQx z^7lcqo_SF3(s&K%yL?brM&2tDpL#wh-5iO;9M%r#10A8NFYkK%m6bfN?Ny#U?5T8I zYoCYJ5e+4CCG)u3_@U1$=58NPLvuqOOh21T-4!LWqNfim?nS{f#sG=T$0+*m4)5pd zYwv^d7LnMUuE*--`B;C_PC9y)$fMGKaN;n%kRTs7^&>s|wo+>X{iOch%ycGi`z;O0 zw)q%QkKWSm#nLF*2cw#mJ;yxD z=UJMC)b%ct!lmR)yVGfLihN}b^UXOf+P(iPrz`s6C;2t&Yy-J?W>^F@5@+usc~{>L zo(}YeKTE^tMR}0PO=Sb?an&7t@ppVQLWLZ3MXrq}Hxy&TQt3fn(wX_l-}t&49rM{c z&{ziP3Pt7ai$JbZKD=O#whuYta7)3IBDrvcIZS8Bv62s+Ta$i3dIqnJ`Ym}sy^-EF z8eZg-Q^|2Jf80cN-TF&L#T!-)qEMxOItnJ`W4^DAG*06D$@lZLJyGy)Yry&6VzAnv=autuoLBu#hQxyIoU)lNIM_663l$BA15_OutH#Z7)`OIyvmXCu+ zT8MkQB59P#|1amOn|;ZFUd%`B06RHV@SAfY-w)#=abdgx1#9#0rkACd_LRwuFW$J6 z7KxZ(1MfBTC$?)L(`y&W=7XHi2S;I4fdLku^H4OVv7FdZBs0tVAjgWYS8oHF?jq+t z+lF&n)ECH(^B0L-Oml1D%SYn9x>(Wuuu}YB1q-(E*7b#&c%+)IR-A z#DKP0nC@Z1ME`g?haC~~Efl{jG#Hbag-zxPud5g0q&Aw7(&|Cbx8^x0j4Q*itB2)TReB5?hXO0f50Vd! zIaY?6iw?-|drpYA4a27%8vG`YwuC%ah1G||u+tHj>V;y<2@QVm-1^{7@=6us=~3nX zYh);HNAUGMMqg7oh1bYmv2wkfBiarK#rUTh`i016IVrqs*2c-Iy3BSO913?nPksMv zI*r(OTP|J}+-Dy51p4Ew$!VU=f?s{^0s6+Rd2F_=W?Q-TacjxO^g*nu#$l0Z7u$%m* zntW(m=9oLUJ7etj5NH=C!m5<-p8|eAbCaieI3kSP=(@ieoLi8^GiHTX*D0}b`jR6K z_yyC=pg~9Sq$NQn6Z8+D*D~RN3~o)QSZWwz$%`eEQ@cE$ zx#5H8I2&n?Y06+MDo4NM)-3e!p;yijCqB%?nmL&~+VVuSh{?qL-h7^l1o;-`jFzi; zwiKF(nOm~3W|Rqy+8&bE-yP7ma2a+D(%}5$Y>dh_;ZM(4d34Vn*XdjQ<;i@~{^Z~q zD!j4}kW+h2zAru)#n%&2I-B|FCKDV69+p)x_E>)+6pbp7m*M!WpJGDGLmIiv|F1SP z7$??iu;d~+TyGOBYH20yIdj;D2BYW~$JfU!Slutfr6&i)aL^H1_kuCaQ;V&MnOI3) z&+O?T>GsVLrad8OI7EvYO|$U#dnvwqCrAf!iwj*s@Qv4bTTm9_N7KhQE>>=nKegBp zf~DUR@gO-1ip3_xlh^B4n|ZO_L&@zV;#cD=7>s2YZ5=PwD?4N8xG=J=TIBDizwciY z4*%LOW&FJby+YxaszvX)%#ojFf>rWCxn7HIkLjV9mO!rXStffsO*m*BCy6tdM_e-m zU&(dW^&q2D)x`V@t(;D9!qNVrsGUK+lJnTCg(h50jg_nR%s5LAMaMx}OmX7-nY>VvU-RMKS6^g)H8a&*a1%L9+A0x?J_i) z&nyGZOAaSYXgVWK#&|j6o@WSD++Pfu#X3?V^JG@XNif0b9JrWtZ|N~ z<>8_F+mFpWl2^L$)|9O|E{@<7D^>tI4cxGi}dk$_=&SPZUE04nL9jPAYt8`oK zT27zvs-5TZz+GM43bm<2lB#-cHM~vzJ9U9RA)t}xd|3|Np7N_DR?txBD1SZPZ&CIo^7ccu~>m+goSx;sTeTrsX;_gxTFow14IZ0wu zGf6Cl$IG$DTImx*=OXhIs--1KC^N%5)r*s_RkYH&k%s4m8rfKxJ+76tvM^99Gh#K; zGDsuGPbA5f1g&g1mMAXE;^j^St=P6pl8j7^Y@W{E_D{~tO>sdJa*OrZkAKyR{rBr# zkj}mLmnEzvkD*J!$_?coDe-i&8|-XS;C$0+f2Gg-u5%#psML=?xakJ1GW zt(o0)TnRfD@`{t4k>skRv(pt;^^|0Nlu&SNeyqzq{R=XUN;ecJmFOm}FiQ_djSKYW z{2PYqDdDKf+Vj^XVfZ^J9AjpO!{JFdtnP(jYQqRDUmK2Us&FKC3x`Kw7@q771Ddi& z{|$Wsox&mW!qER79Xrc-uKgqoy>F9Ubfw?megqyK=b1`KDECpURZA%1U-At6Rv0`R z@f>_*IQ|~v&)KoYvxx3t)~9Ro3_P+5dr5Q2AdaSQN5eHu4>}mnYO$#=GoJc0n~P`X z^(}Zt#Pvx3Hmq@6X5INGzsI0uEnSD|adi0{WHw+HYY@wM&bE{8g89sd+NQ-3GaY=& zSl3>|IycYcezN{ONR@=wQCe7w4(s_d4g+*(xHkvO`sZNI{%knCqI=OU2NPLuK7K0) zT?)zY^L%Uu|LsL~Hp<DWXL38%(jy%Ua>OAHT+VFg5IcwgVoaId8 z7IKC@m%BUMB=(?-#N|55!AMt$Z_`nFpK2iuVp_?-vvkV6Xeo^%Tg!yu_OfoOgR~gt zB6Ci+m5c0E?`-Zacjq>jRyJ-j=#ah4o@y_Bf3au$gsZ$OD#Tfyoqih8>ZOGJO>9E`-VBx3zagw3EeST1>D(tUvnW{DWlC0>7YPsC2I}$S&JQ` zK*)5H9DPO)&}wE27MtOG0|m1mOJ(phlbF*3ciLWo#9yUiWdG?_{@a9qm{09Zw|zqe z%1<;&6R^ksAzeZWGyIG+$Aozb#N^Wv)1yS9hMHvc7UmT$qC;*^sVEnyuEnX{V;Q?3T=C;kUg7uLzRc3 zIK>bDcJ)VX7rGvKu086P9|k6JZ|~1~_HsXX-ws6T7k?ax2e3^u0xMkNlhG(<@k?=Q)0D z?&TD3xZiz2zv3h^QX|y#_ebM-fAR#{Xhd16(P@|(!o5p&1-cif(P3YXE`zCb-1Biq zyQ^`Fwd_Isvwn^m<}1lH)~7c}rN-`@D8xNXN4X%@{dr!}D}-*vII;-O$X)#;mspid z0RMgCi*)RKZonYcd`8*uTzpgpwujUGb|D=XSmU^vl@8;PbTkSjJMh|o$+I$$&+q$| z!QS0W12eH%2YzWll@Bw{>)V$xlcFZ)0hJG1u+*_V`NVOJ#g2^ zUfrSB=N7$k4UMRGg}H!}3gE`aue#BQ39ad8s$M{@*oZJCAD>R5mD`Ls8bo*8XZn(+ zGSh1Sb13J#%d!p*a`Kvkv>DMtEbSd-SZ#N?VCEowPV)V~#!ZIbcb9}%XZiY;u7wNq z7cFv?F3J|tu(_RFZQ4e9Pj!<8{hZ|l$CP1~oxFaol&W2vr9(|;ahPi_A7?0Kev$L=}SLUQw3cb3Jf1pA{Ip) z6Dv(Jb8o3kcPoeO26GH#9qoQU1=cK~YimKNtfY&v*FAC&niBcYg*ojH6xbG3Dsy_% zx7dU($9U#@)+m$J)k`HhvW)%F^r~{4MUrFOYDGTsrUDC2mP-9@3M}qzhT50SFzI5M zR3+~_F;|7%WK5nPQNiQ03Qa38OPZW-UHD4XL??*<(v`&HQgNQIr10+GYQ?uT&! zzBp_2M*_!W(18HdT;hvCgH+5C-GQI0I8F@odc0x2dJ8prsoBSwL1$^tXdH85?&cWg z%k|+HSf^(8E3-HG^&r;q?rvgkSFjq(`||4?Hzzui8SbsdOfUM!mXJSgy926L>i^aH zY}V2<#X4mF+G>2_`E%qDj=33X%nzn-^$>j~f#g~^2CF2Ji7=33Nio21Ivr!%vmd!@ z1}3>>pud)^@ZNNUm8Rol_Y5@mrHdtuW05tw4F3$&H>Vr5)PR?J$W&Y*<5)2R>Mi78 zhNfeXDFatob4`!o82yxn!?QDxXG@<8$LOLW^2DrRt!}63=~%< zM>vx??O*ay`8hqOkBxYCm#lB55zWm$A=sAgQvOl@B`-{Ohu0V8v%WE6D%rz~cVvFa zGX`20U|N6?(I;73Eihu#KzdPGJ1oz!7qr%hv48S$ZMPBUjr6hgp#OvCTz^vNg&b)_ zV;_1SryEgloD6aT*_6RgJk))!>CHw?*N?mI=9zf6xqh_SmefftKXp!<)HC&NVI}?T zRv$gRsy_2@+g!`@Lv9;=pTt3)i~i=O-b?J_@gh0hb6%rWo|&o^`q1sc`U?ZDd!+5@ zkk)JAVb2i7L(lp@CV4jf)+lYV$7OxrXRr1Br=+I_S8tdWS6R`mSz8zVz*Za2+n(8? zKjPOQZPRRhs)Zp@mgI8pzV4{ZpG`&)%$SbQ$di*?yS3Cvvz0nwAD`q}GY|5HPO3hp zr(?55#?RA;{S0!50~2N4jU=(uYUTE=MA`j5QFh!k$+$487>MxWlZ;Pf9#{ro@Qx%*wj2 zL}TuUD^796f|{;SDqIoT(FF++E_mjrL>TLAJJ-1IUO_ki6D6}3*b~EEmtzf`F<=Mt z;fQ$8z35?bB1ln3`+Qa^aY>iH}(!3HNxuHGHuSl|G5Z#KQRe2* zsYkYv_0y!6>~UE}ZgDf$f?LVEaQ!&*64#F8fqMC5;M z!i>r#n@KnKu5A2XLI-#ezt6~Zr%w*^q3H?vK-V{WYSb0zz~Q=bku%qhSN|{1cz>Of zT**;N#{#9?%yf|c1+8V_eizB_W`?IX&9Qlvf_V#Ei#eJ>ZBSqb=ibb_Dp=kLz||bC zp%$|*V~q+K$LROF#yK!5ntAbDPjKDxAv79Wd9VMqH62-;lfpPxZSKS@NT+nPa^hUW zb9C3?biBs#p4`QV49*wB>1>KyEhWI)MLz#>laKpaN!>PNF3ylgdqv(p#|$Tn znYY-8a7cKdQd71f8dGO;9BfKWl(YU6yID0B3o}R`%XeEV?ZREvC zdL#4A@TH3xmdr89nQ81Ja5aOwy*WIu(mlxQV@F=bdQc#qr3B*Mk3ekgxC2(_=m7SK zM&52ZlYT{Gur3;j-^mrkq+==P;nk~{i}{TAf!XPp;bp|kLv%$)v&Z6M0cLQ0v%!`w zTU`tJe#A{C%xWchciT#hg3A5*9fxuFV$rFc&`}F9B!_;%&s%9^I|$Q!ht`$XpyOz)QL{-OrPCILp7&Mg3`ji*)bmE~g7yi?Y;FieJ0Rr^f6p>QoNBcbK84 zg&Drzq5t`V8S2u5SZRw2B{%)aSqCCvgFnuX48)O%bV#sn=NuW0hUa0#M5D;5d|Y0Dfwy=c(G;Na#P+f|z9n$o|6eE@-jK1@>Odqx_~snc5j6#?omu zDI8Bc$)g2?zI)_gxo`a^2#ll zf72|7KTD?Ipu(&7BYLeylWWXYcvalSe9W;&q{WUTDdzpG`x>3hNlX!|={k8hm06um zuBcYq4Gwi%qQ-3{j`_O4+AIRjY2hg4JZm;E93{`g5Wx90@0Jc7(>Qnb)?%@a`)8h& zPvbtkm~)eFL^hnKlG__YU*y?rIzVzUg$&~cvMCeu6kcz}Fk3m73?ay)bx4t|r*-1i zBS}`?(Mh>FN92nq8IcfI)c;LJWtS_4v~|VLI9Ci!cfsWY5r_{8M=f5X6nzIqb({u6iDd){SWG(6TJ8(kbRdo}4 z@yTLz9gZ+FkfS;M&2Awk(T@1U^J2WRJmf_G&fv-=#E}J z+}Mx8JZ|zIhR)2T91+1B8=i**M&NdNzD~TS1oucnxSl+{O%nD`;A@t}*XS$f=9FBt zypW4Nr?PQ#UN-8|4cUi$!#r}0+YJh@>*OCcpC$Wgqm|#+j!Tkjl5D4+xx=Icd9glO zyqhtnoNP+mS~uKY=!So`@eJpS3oLk^(w_YSDZIyyNQ}UZjBxfoGxLIHA!l#WiMWSc zWw|88{9+F^&v(Cm&jt?j%%NN^Qh1JVlJ}td-E%N{Ed7<_QsPc2yy9aOUaAt-7Q&bl zR-XK6ShAcLMn`lHoeaLBm38+uvLCK!`G}6ub#555$`z}x9njb&9ibvUd($d)e5(k@u?# zW?tiY9$(m+Oi?X`*Y+!XFKt$M1=MpD#Yk6aUX#6Ht6ZgT)s}K^OABd#&m&^Y@JI+Sz89T~a31)BN$mgFTS90ufr5nGlct@oOi~ z5IU>L`m^7Vd-aOn$)i9My*_lctDNiI zR%(1EG>C7w$ST&h68S93HPWzN2Da-WCFWTsUB!n+1wGS80I{`H5s zYamRARd}#58gF~4F_<6U^Sv|wU*?0KBIEdmy`WARDEh?y%On{KFcpHks_E*WPxCRI)RsI0N}x-}PL23&JeNsG zCqI-9Kd*E+?%`Pt*Jb8>50^h+L?rKDyJ{C;(|x{|>lI+aORbc?&`5V{jVz{re)fc; z@`l+(*87xj+u{n(a2HHTChJWOY;ZXxrgJ{D;`)C%KRPXn!0!|E4{}ai!*kLIZ=Tma zX74%AUB6lCa5qqgUfZ(BB;}yN=WHB5l7qF?=rO;OgU-_wUZwviyn+VuKDM5|+PR#I z__fnt62-DMxwxh}X`??b1ISv|o=6V?_be4TAKoyzBE*OD^uOH0Oms%UlL+Q9vKHzV zffM~X7jdufnERCW?mF}}@Hz0laoR5lv0SIuJfwq{F&n+x1eVr_!0HVVxIk9!W3~=K6PfdKi|5K~*jM$FuEsdt zPraD$lbMa9O7^zb$-zd>i@iBt_bpU-b>cn3K9k(}d$Mv}&AcpmU%j|8MSM$GyEv?q zfVW2^dt{1Svq_d_on7Enq(np>-OJxyvFVu`9CKaa?L?nIU^s?Mia@=%2y7o8fd&t` z7n_y@6YECW?|d$k=>o{qqRCM*mWy)mbZ#!j)?mN=Ccb8sa?tu}Haa~}ctzdf^&xBC zoqY=_oTs;}Qh2pEqLWI+8gZ+WBClWRm^q#zQMZ40XMkMU~bhfXJl;;h0;9&m-!w(U>%MN31O&voo>z1IxJSv6Un}~ zxV7{OyYlY^S_GBPg|RdXN4fqPk&^?%dHSk(PG7?J?%v1rj4Y!^liA?r4|z`=_kVfD zoZrplR^7i+bEOY%FQV@+m_4i=I0m~}%kJ<(X<6SFiGk!_5}6Zvf_cG%8_39Ee`R2- zFP&)Q_-3(>wG(rPM_S8p^-pR0=^s?gi^TBMH0*4Zk4csmGIDdVw9fTLxFhpYZ_?8j zNN?9(3kmZ3CDHf1@%Eo6G$XHfYh)hcE;p77^pvf;Ngv|fDArlh@OwCOevdVkt^vjJ zgL{er!y<9&mI0pD^yRg%67|GClDWzo<*Gy?x;DAXO8K}E(nvCxi>+4qz<&jK9GxDo z`Tg+^$UQOV^wbe=G^77+gtq~^$Y;e?Zz|=Q7E8CU{~)z;6x5cy*B$zZb{;l#F#eJG z?t`HyABCza<^{DTSEy(#R`i-3ddcS>&iv>#hT3L4$9iBb{zZReBsrspGota$j`Mm``pbG*$gVfvB)g6;e)Dmv^GvQE z`Jh`bti){d9~n;H-`|;$2zjqZx9fRWxyecbpZ}DpO?}X&Be^88jrNP?b63?F@+6m52NQ3$brfC{O3m_eXAP%R&Q!I_9C_rbcqEYOzcV`Ukn(N2Mxw zALjjJ{Qf4AdjGF1PV&KlKjhbVe;%2`$KTXg;9Mf<SMa`Tw0tes(8)j$;eu z`ILX~d3Gf9Mg0Hj^I%zIC7&A5*GBK2YsDyBYsS3k`pnx6qaX0nZ}Bhj1zJU+yj>c? z!}IZ}26Km_isfV{Urgy1i6K1=n3lsl?nVuz_6>4gV}0?MuWvRvzCB~}@Hf7$3|v?w zWhyVV<~8p;(e{4PC_gM{*h-rsZK?XDjh|^jjXy@I~FLkvQ@v z4eH+cxO}3a3{5PQYfF4EGk|_fGoG9N{D}H@tz_ldVrfr4@!JM+fBtE>A^G?+yp|Yt z{FT5F%-tT&9P<{;C8tkNd7+uyoc>qVSMY_!Xy%FEC(pYjA6GlrNPIPNltDg7;&r|< z&48AD$Wd;zlk%&J<@}d_5IiIbbA!|2q|U>nZ4D&qL5Wlv?+ukU3LTmoSeMDe*d|RS z$f8*EZoZh$@!Kqj84=_h^L#C(hD(u%i!c6d5{cKP^eVp1qvN-}^t|y)QqB#=d}S1x zuT8_({^SZH8%p!5^at?yS0J}&|1k~Amgk`?)J{&*XK-tSAG$q>g#T|n=4kU!(8faY zDlvzBhYzx5M8bnS;Fo#%@HRG;(f|CGm8E>Yb%;V8zFzwEeExGS#AP+d#U*d7{7BxJ zXUapSO;@ZW-M>iAR#8FA^YYI_ z_&9vM9D|$7<>F!)L2qfKO%(ntqi3)rA0^fnGMN11@9o|=dwe_8ybd)+v!8Gzxk7TX z#tJ^DG=TZ_k!h&kh<-_WAsh4guW0Fu)#O+=H=xh7=p)w6w3AuA|Hzp4%#Y^d|E|hB zkt2Cnyv;%uX-Z|=2wx0Y6p1kfk z0W-ak#c}cIS{gpw%*QZSYx#EUkIcT|4NLPVoV>#MZCM^JOll$l&V>@Q(Hk+LQP@ZB z_<`{wTqZXbed2HNnc#yD=g2QB(y(uAK7tb2Cq*8-a;XnG(%TDz9+SyY_Bv-HW%K^X zUHUgKa{hU3oyPModTHNUi_-K*GB%TkZOn`)8v`Dy@|kPgP@b>)EslI0$MAhv+|+=d zmds&~u#z#X8^!eV#gC~`n9uLO-6apR`m@&i{+IOo=8Z+uSyOZ;XPxsAIynbuGAWUCDgsm^gWu=ZN*& zLU7xP&g94}tRPo7h&?yI3hmJaVd#ELi~UWqFtohFYeJPc_6#^;|9|<{ZxZ3>%AS?0 zWtg`wR_e}TzH0C?7#zqq6=jkoD??@5y|Qkv1AaaUL7jh@yIPio6K$AzF_hfd0cY4H zEW^lr4Z7I#|5c7$q-VUGAlK>NITX?KnoYe-zu_ViE;czVbLu(Z(C9E!<$m`;a2EOv zHeuP~gJM&i{94x#^w9DQg&dz#Hxv6ZY0rDz;;O@kSFf=g1!obbzKP1d)IEIIlCYsxO~^ zK&*VH&(1S93|(t!;dC+^%O{yI>)~OsD|CVb*F75Hnsj3}-J~XDU5J&t^_|f_ektyn zCnE44@}6VpS-Vbe!!HN?qPNZ?Tm!cgS-AeO44*q3lB_f*oV~)Y?@Pp)Hd!d{Z^AA2 zL*lWE-br$x@8@Yym9LjW4}SgMLo(gyfIe=)Fb~jR!7ZLc)HEUDCcnSX8Sjn+qmr`* zq4k(A^t231hsDdpSO<)37mTZMTHNE~Z);>?AJ$>1HQxylw}P>W=Lyc2m{VNagjYH7 z;`zY=d98wR;I;;{$j$k#AP-o4K+;z`(0d(%G>rz94e7Z%RR-IDco~-G0Dp2@#vh3o zUyIK_yA0j?9FSSoP6&D)0*i_oEH0OY7gx&Ar_n)4ziE#fzI>m5X72WlOgw2=h6Yy; zNN67i3?(<(i|@Aw7R+IHRd~I3J|y*iIw2+{1ntQKdYxx3^P4hksvaxd?CAlt3qjKn zS{xAi@-CTR;_IlPk8cFI)Sw0$^!|~FnoY?6c0C~V-~=1nFgmdKzBOfH5&5+tulWBZ zKfAXu6#pDbgfscm!~-S_>2gpKsyJg&awx7;(2_04MD>{_%-eWSO7A#eX15S%wrR+& zko!w7Lx_<%&Nm#e(K!U&ZMA5|_f_qq9AD%;jakk(%ir5-EWNAz`o-xcY-aB8c=Era zINm*z6ET9krS<~|peL3ckv68_qw`?_HK z=Jl*tm3i^xNfYlMl*D`o6dw&m41aHredMOe! zVVO*iXZWNL6g^FZ9XZXScjRGP?w3Q~9nomnGTa}acgg`zU&lQUm4F_!bsY@fptd6l{L+sI3D+?_NhpWChs4-X!YwH+OC;l?ryBu}~u z^rfyc;l{{A0`izK;mn=q{N{0u*KMo`wwwp9Fh|=oF$8_BxM#e{@lsrdcXtm<`7aJg zOA5xqnau5NPQIS6%m1sNG2n_%s`k$@{jV)%`WJWd^{f7NNZXdUHPt3;yJyE6D?MY* zkJNX%ZyrRQQ?AStWzt4ow4zv66?FM_tnN3 zRvVOPI-Fj`d(OD2QsQis6S^;ULE>d+tiI&}aixQ2k&?a$7c60|`OGmFoFDHBKb|?w zy6A!iYn^eh8C^X)lsGQzi=4nS1WRWevv9%DfzF(7nIYKG6&rL)l*GE=^KCj`E71Kz z{#e^1j6K2h>s0?gXG489GdpMiIYgclwe22((yi<}y~rB1lD@^!JV&1uh7m0zurfEC zS)n{v;@NhM2Vqz`fDT61N#4E>L(>)P#k33OeLoa0`EmCcW?lRU{a>#AAAYVXA*X9g z-%l@Q4~B*#+?>7$J-v&E&k^zFFuob1nkj#1VVSo2Ba znfV0XoBcQ+SGmu%&|4ic=4z3%NsF<~bvWvvMcFi-^G{?QdN%Vcc$QRSGV=$I(76-A z$Ni>7PyZy8EYQ*Iz_Sb6BKgiC;>T&ENOCgph;${7yFa*4fNh%mI86N&IiA8_{Rc%?L?WMp!pA^jQQoz|qft*MD*<~gfO~$HqEM0Sh z&CuAk9A+OT%SHFfy-8(Kj=$ppf9_RlGZZA4WKLX(WNj`JnMs!;*~HD4RdCqHoF`iq z2DVVaHOP*;XH#mM63lgeddRsvwg6+djN9A`NP5Bhtcx`Sj%Kh zcOd_C_DAkqo{21rg83FQRT?r={?U*R^z2Whv*sc>s7v%C_|h+QRSi`T`NRZ%|5iGO zp0oaYhpvLx(U{2nPOCT3s9BqRZmd6SPN7q7N;IO2Sr<7T4f_;kReLks31T52IUdIrFa;7?=adUc*>2i0#QiJ~5#24+ADPOUDCKI`S@LFuRv$ z>ATW#$%3`&&l$LUjV#tTvXaUSSZ}A_;XLc-v8?MKNoTJz^ZfRwW6Xwpe0)sSi3~&| z)*~)>8j*j2%;A2z`p+0qJIIKx&FEJ;$7~6nr=%{)M?q)uSNDx%28?*c+SAC<^eVo~ zhvjRsk^C6X8q3GU1vqT^2_++q$UJJq*N_67QXBCzhOVgX%%5CGk6Z)RrmGg<@+Bi~ zA0lT^m7HXflN=oEEYq!=q*l0{+$(dC5sSzyj&PBlUF;<(hF*n(HlnZRBIA0xi3{0B zpX!b>&x_e#x7=lX2X}eX)lsVMwUtt9=0&@Fgw=9*q>zKKIvsB)=(%s-$Cez-M z2QD?qd)7U!c2J=nUb{)cS3X z(s~N$oyZukQQ*5?flCo|q;f3AeJqw)TgX7}HN&F?{QAFS96Kp6aY2bpsZu5_9TkXJ zMu(!OA3~4&p%KSd&T@YYTtwgLGk~!4^SK6|^xJ!k_$5p6eOO~J; zGtRd971SJS z&)=yq?wg8kMHM!(wzFb<0HR{m^mIhynkzHglgMoxAy?uXO&=v|KD)@4e2YeBj+Jd3 z7hiADlUkLWBLA&j2zyl>nC)IejcWgL95&!Mx*rYoPqM?eqj33K6xMx@!sIsm-s?PP z>dSHTiM76JSdnAr&oBC*;#eOWK$mG)I%2n_GmHDb^HTb&o~6^J zO+JU*$0mEa9+M4lvE`WL<1VU@f$;(9uH zWLfm5%roN94%S918PPq7=aTCRFeKlIrsN!_XXfKXPcpt0nN2p9-0#tR94jDC%&|55 zml6NoG2(s)j>(Qj9G^|DIGP#o>H?_$XIk!MmNbZ@*n)O znrE#39IpmG=0T3X*s;b7pQ~3%8(SHv4+=i$d-u%LFPmK_?c=Pl-jAMn?AHg(=@s9P#|O^(GjLH;dFkj%q+$^FwP zbH1^+v;L68bvDTApakiEP%me{>Sd^nQC_bzO4QZ^V)>|-pV4{=Wk0A-Mb5}n)=Sjo z1M-VGS-q4=vN=tO?OR=7ysE^9ROTGiQ{mBg@`^Fc&6=vh@)gc_FRtkLi1%`?N`y?H z2kfDWb08|{8mO@iN({(X;aNBC1<6KsJ?VmK@h%wj+=VVfH3mm=zd47TqeY2D1C@CB z&J~Y`tI4D*;TfXB%MBI0i?cE1V3uR+XL^$bIcbk4qS2a$gI(KbbcgPPaF|e=mnwV4mDtwj?iEg|jjVTIl$=TYj9o;r{PTK4(_q z*^A?S-I+h=rm|-y^k3`|nvMK-kbAjnK(`{!shIV+pTJod-j_#^QykNj`D%Fv)N025 z-8Am)jJrqrSXYzN)oRrnlNjkv8cq7J#n7d@E;JH&|W6Wnh;qnGi9 z5sObUzq&VBN3w()*!%PDYsRm}tR2mv!z_S%H8b~x-kd}EV#b!w%!W3YG4dU2IkT9f zzLrs>z%H^ z9x?ZUL4&gX$4k1}XCcLx-kCzy@3zrFL%;rizj{n|lTn5?^4DRdM25ANs~ua(KgCL^ zFt8A=9lx^! z5qgc;q1J)u=^BVb%XBE$gPy;IQ5b0zjg^XMRJf)?nBoE&3?o}GEgj`D(#Z~{BXv+Z z^iK*9{k8xPO39~iZ*kY04>dXNLBri7baHE16{M7)RZg-qUM&X(sN~eXQfb(Vd(?ld zvFpAy292Rt>K`j8&jn$zX)vyZ491+jbXfA2YA2bMjZtu{%=ct|6fE4^)oU4z{x8YU zlLr}6GaaY62ih8Kf?Fh+_J*A6IF}Fm7j%Ge1|y5t=IS*H;4_du!r`r?a~C&ptm`UU zSGvk|i@T&JsN{JHXBkdfWB}Ls*Ig}g!chU^cm=kO=6h0Ig9K~tUEA^XM3Q%yqd|BD za{b)*y=_UC@J$_ObGRn%Cf~^Q!Oi0WZabu-^&=BTpENNWoG#%f`RF~j0Qfy^QXtmb=!j^4A!(q+jFSp?aw-X-YSGJ9<7JaeqIrOzf5P zDs#<#e1Lm`7-miP48X#4vPF?PgdEo~k2DH*8%CkkMe-oa`TDM7rwuHm~9__}tG zi><_cawGCPBTSgmEgd8IUYWT!9;!DXCWLH%33I#d=A+N+JXF}jp69Fr+{{Rn1Eq;F znT*5cZ3Zd&dPLNVjM8^BvyhDJnTL|u+p9!VUQ9KpE@OE3H z@ZLr@<06ff_r->EDCv`=+L%PSIWJL8lASl)KPW~rEBC6?jWk=0e9k%6)T&Y1K@C0Y z0Jq4ctlU8-V?23>y5ZR3!+ZD`@*vax&&*#3a%qEWBx3t*Bc9Nm)S)Yx>DVlEsFRIu zH#pPREE|{Kv!}1J^1ej=%zU1V!7zn)!aRkyYrewU!GW`*@rT6R>yX%Yp~nEk@*@IX47?!3*$$9nYsHO|Jkwe-}wXXD^PdcU41yz}X?WC!_>x0?^~Hqahfk<*#cwn-Gp?-NO*uk*tgZ>m_{8u2xUPnd5wqSR1)EhmN#;%mSLttkum~$oycY z=OG)F-e=;rOmonHR3t!RF@%k>lP@=EP2lZxCVphPWm_ms-vW>&cU zq=b2D^!#nI!q_dG?<~}yN?m3&EDgf)8Dt1glHYqb7{vuTSa=Qm+%$?a3_A2sM8T#v z-M*P*DVxxFYe)7 z1ATv;p3@ttF2JX7H)(c{{5yG;(SN(hn3l{oaCeoR8jEb*NalS3vrNa9%9`y8c=}r; zbV>jo{|dmWZGkY+Wm)4z0Intk;^BuVyloW)JksGe@4IU7{W?*P_huhW=zQ9Q`uvRc zaGx=}UpkJgONXLb0ZhCnseP7=WgPEWYUSfyf3B&G+llocr5u0kB-husk;<>#r5=5j z$2KeA_<{ANZ&s*lqN|#-dQS}&$>V#`Fk3^GtG(<2c?cMsf|k{g&&)1ZG>1h3{~bbrbfmgU9Bh=gE9T^PXowNAru>dP9}A z^3u~y#yNUO@|L!8X1SBRT<9nvKP?i${m!~!);NB?9GWVu@usUa+TYTk`Gg?+J0%eA zCpFm2TGgzh8XVrjd(L6>LGRbWzGoEb2hs=4HQs8v3CnqZ*_L$a>oVL3~e{Gin;{6)rl-U}5r zjZ&lM02NwUxiRxR97kixmp5i^aG4e@D*ne1@|sO{*>SEBH@b3u+$IsDUh=%3XT;D` zbd%4d>#sZKbn?xpSw0K1+AzmvBG-xcblH*rntoK_ZCS7I-o1t1+NFsyfcIZN4jQGU zjb1KKX6`hv%=21sK7jqEuTz<==b^+y*2mv*O26^^xc?<$0ri8X?!9+&L)G-_4DcXER5z}{jDww9s6g)Z(}xWE#&aYqurmW@K%vM z-(A(p`(JYBduGsAyNdkc3T8KLOO#!A66IC@L}{4F*FYaYT322N&nV$^hS}G=Mi1Xa zF3udz<3x*5S-fBJX1|@D;X8GV@F_81@e=y}9E{koAQ2B=aNdgjJ(U!*7`yQ|-f%t`8$$%loZgVeljm?>SV9jjm+hIrr6l968hxMjXG* z8u_9`1TM)&RDL#W`eq^IDw#cgR(1uP->1uW=u5g8L+OKVLhtcoUayn6&W}%&|1$LE zJN?Hn9unW0NwUR5FCW*s;L1TI4s=%I9Pc65^;Kdl_d%Cd@n`#L5nCJvtH0<;s2Gmn z1GIP;ZA6l9BIfTkVC`1khefciZ)QC|k9pTu$iJ@6!W1j^%9Lh=`(?o;k1TAo!g~p4 zChW4A)5y;TaAe4QER_g`zIbBkMhuceGBRG<+sd+AA-rVta+Y>+K2OCU)VtE78XnS2R}lk-2BzwFJNR)r3|52eBBGIPKm z+0ai?ESnnnqVu%C)eW*oZHCDrV zdnDAXI}ZI$Pvt%*nNg)sy!tRFdSWCjY7;(x%)#V7_VSv%gR zX(yL#f5{_0|Ndr?Sp1YfSCxx>-5QAU2{}Xu=5a6KziUb=c08s>?_Ya)T)RY4FZ!S~ zmA-N@%)#a+@Z%%U6DS-rjZ!Q=Qmx<#S#ZcIkl)rGN1UO_WDSC`$$ja*<4Jo z*-+-4E0Spye6ehEBtksX(2_jkGKZ!zZ|hHqXAaPP<^tQMry*e(dC44Gxp9o=#TP%M z&Sn3kRvJ?I_+|?mi@73?+h|{W^WxqrCKVnxbFpDabLrqkj+pOrmlYAPI+}{PzjINm zFS*Xmzog_7=j5kG;>G1u)Nsnf^x943#pFU6MgFwpKqUP5KJQzQ$LlryedT`0&Gr0T zsz>6uGi$bUSkvTQOF6h$!ruDhY(De5`S@Q4d3;uGEH&eQOV(IFv^Fy@yG}AroAF}X>A8uNhm++Ih*yqU+zjKiK!{{6BOinW@65~>tlini_w&R+}ZE}v~>B0Q* zJ_6fT(i_2_>(r>pV63jvWRe`3ia7D0(FCl7D<^D^Eg7C6e{>uVE1|^Z3klVZK$D z#!{MDEX$wyyM*1nGYVu<7Z+HUT$wHhtws~y}myV z?T*0EEr}}63x71=an*Z!D$d37b9Z-;ln+0p?NUDfY`*@5Y4oD!VwW_PE`5rn#TND! z>as^hUVFk`=0PX$-)sF#ig-W&E12iw)-<>`&*NNTeR<(mD2I5y`0#js&(Hn#2mV}J zTZvg!B)8aq=u)0P_m5PRz05(Kke6RA+NxOGc-)@ib#H+kuZJhd54LJ5jqJ!F(zk1~KLRr{$zz_$h0D0>Fdj?Bfehs|W?ni45@)fZ8r5lHo;uQnnN zvA-J25BD3k-OYzD}f#=r$2GU#eQ~YcD z;o4I2*AwV1*_?~hpX|i(=1-aH;g9MMBQRk$=c+=;vuh8?NqP?#8kz6e&ww7}$mTZZ zzGTimsmodUaTP+bkoS07N;C0fH+i?Zu~Ib31y7m;dN8a;GbegfCO&7EA@l^F zXRb5i6k+(-jXA151pjcsgy+GmmDBkYnhB5X16U~tzu>2FK4=8L-5c01SGq0-?!9)%75>b&aCnE8x;(fUIx_RUb%UB z@?2wM!kjXFOw$^YwxR+=?-y-BspIKOh%2n0eE4 znR&(It$^OcYE>*yk=wdo=*L2##d&7egw#OMGgUR1%^*9zzr&di1 z=Gg2PUp|k=z%cCO=R41fd*$aA#5|7?|G&w3#Rucsk_4>0Y{s+z3p(tHmFaHI_;*kU zF7bJ`#%H2zEIpDn<7NE6u4t?aLBJ0^Uhw0`G?56opd6@y%dUF z^oRQKbF8EAR#uJY94)!sBzpIn8<^2;#;x`i^mdPz*T-Fv+J(Nw7J6JEx4ZXK8E`&U z>e2J)Tss6a4klnX^Q`Ss%JB6ouS=U;G4=&LssRREI7#1PJoAW|y*ufl6MR#H=|W3D zS1+D-!DUz!y-%*VJ7FGw?(?ejtDeY2b0-U8-D0KjpGquP5C#u>1Ltot;dqC+*s(EE zJIDn??gV4ZU_E@-WMZ}}Ki})I(y56HKDmUV$qe?NT4eJ6vkWa??w3u>AAf#21Xs(E zJL2`Kp1s2RNU2^X9d|}&MJQIx)??hn3~UH3L(!~Qsn*67+v$EAcSVoV(HY3U#(!7H zemTbL?fV@ec<9G`_8%EIb)yVftM|!8xMC#p$6Jrp!!DY&;zPVH4dr!mC3$UnOY2rP zpvi|!tmNw%&GXB$+6jy3g`@=@BW7k|1?R(NCd5i&XBTw18G_$DA6vCEV-Y{EW;q9B zz)p|C@od~EH6p{s+jOGzh)n)$OcEpT2GBMa6!;*^d#-Hr5U zdnA*6vog+x9FXH4E@(C-6w&RN+ukP=z3W&|P)#pS$2&tanY^=?9+49{<2TPj|9hMy z)#Ld>-uchYdemyp8UjDxz*GCBksZWlsZb}Gt^L#h` z%j@l;|Nnl*cZMn{o10jte0jGv#k%RT z_fig8_42BFJ1FJeoXcI@L$;@EdDq^vC^J6gervtw;^%$6+IQ%eQs@3)uNM^>ru_V) zlb6#N-(=6X1{w4&QA(M`^o-2ynN|jQI?E{b?UUrrn*?zxV1GH;AfHN^2Uzux4_mIsMEP*Q#(XalQ({-91t7kU*E%RK_;dK}s zriA0>N#+Bx-q2)gIKp|jTXhb!s*N5 ztmR}a))&(Q%zBc`$S^D&5r)a5v{=wD47FKHiJl&cwXCIhj?iLHKP_Ihp=;-K7<#qV zV)T)4{O&DTZi2=vf88O+J{hd4YOz8&(diPi>VbA){ z=SJw966t;;%gA-M5&vAuI43%ab+9I69dFVBQPGH4KlV$0WaAa<8DFxQ9msk{1^%kl zpT3dYWMN{Y84oVfAv-J!$65Pm_R|cnT-Nl*lTGB~ zi(<`KzTAw7EwiARLw^r@*0Ke#5iha$=+v_UHbV!!Ju^d5RT2Ot3;@ zw-P!1MgiSfiyW{ml}hwMdL5;Uagzd{uCTA$!U|hcm_xn6B15VwkWn=VHt#h!`Ba0Q z8V#Pe34(Xz5Y!m z-YEz{Z#3|3Our&CrGnGg$6XnPkPT6|k`RRkI=U3Uv9DrBZ=xz1yAH6oQOMk>iL9G< z(V^P~9lC@@p<)E{6&;uz_>S2Q<8+w3kvVyNna8w@xz+3u?`WsPQWv@#mymrdBG<+G z|JP7yY2V@ype;<^_9>t>n=Hb$@tp}ZpjoHJAFkv!#0t4HdFazmG|6xLx zcIh}-kcM&W7ZkN;PySgNnmr*?)iWL5@5p8yp<`$wxvCE)=3bfbVZ8~_wJsoSD0|~m zO&D{M^NZut@Ga4V2j+B~KV?F(oe94ius`zBgcu85a}Lb+x|N3er`fmposUV^*h4C% zFOI$R!%dh6eVzC72lM~uf;j#?4`Y(pYrjffk##F$C;AlstI7Mbe_>$XqA&e%&U7)V z^3ivCKK3jkuXw!xb!*dUF*G03+55S@njVR9WGY6}B^Qy8Ug`o&>YI<#{N8`AruOW~ zto)+@<&NiJ!futQ_BzSG^j^gLc9u<9DhW3@OY}NdIpE_aB?&HasbM=Y7CFgnty&PvZv%Y2@uJi$Z(tH*8u3}zScA13o|5a!6 zYvwI1X20s^Oa<1oS0H%46_$6U-;{o$Q@u+iH`pTk-dIE%Q!0wn7OBL?_%tn*@3*b6 zvX>Q>9xss{SIQ*%yaGdcKK8B349U?7Jc;M?6)A9j1KlG-t#GoZ0(F*IHvupo8B9Jh5VJ37pjzjT*|E%^?nmFm z;2@NY*WgAt{ii`1_?rSSWJw_A-`3!EQUDBx0+{O;fPF*#5zsggaa)<&wo8MR`^YZZ z@%hLpZ?z4??`Y3FysQ|Fmb&(GVeGle|WVP>T$)JkTiOhp|w9A%b;o;|e+ z%yPe|gZ`=x?b}2l<9;Me^`cSaqeJ*#WPYH7$2=WO3(3>Oq~r8h6GBF?M>*Yu{2A%! z`S%6P{lwYo?diDPAsuB8O^7(dj4&q?de%t)A7lJr09{^P({b@TYu<-AKl;Ulra5GO zU!Zmv$5bBwJIERG{74<2|G&Ou(q-m(?8!$1{#wa%?)1QXY^g)mMwm5yDi6ySGBdh> zv!}?16>H(g19@((qPy!B*+&yIOC0Gx&Ckbu2l9lrziIQm(u%_FOY+o99Wx2Ct~yHmUj_ z`%_LdOiIb^_d2=Ck1Jm2dNt+TS%*~b<$tD3`>aUW&}dn*-I`@xFNPgVQFklnHFwn- zFUy>yls!xQy)wI7d#-q>PX4xHYI37fjk@mFBze~H{p__r|BhG5Kvl}V-)B9yG~RV~ zXVC^Pd+WbF>rOSwc!fb~=Ou_^wo!I1NR;vPZIwHjDF5_Ll6{;{sqC2`mOBR7RTM9M zJPq<}p;5kYe$m&KKCaJ3xx*aI1yd6xIsSmuJwTUt$zd@xFv|NodWm^%l+z&zGWBVq z+~~`B79_~Iq9n1LGsyCviSp+$gX}q%AQQ(O6xZZLdCPs?k>~8!_2qu8xe}G8st^{a zMlFjH2QRo{{XjLWGn5D&LDuj#nZzf|&#I(?pD$-#4l7YacIEH&bar1#coQ{NH>dC9EPqZr74p?8>};*VnKHV(zq#VjbUx=l zoO3y*Mc*;>)(@gXt6ey%wFrl%Rv5|$(qVOz`$O&*1MbjaHCPM7)iC^g8OrSVFsQh1 z)K1f4#9d~c{RlzD8DZGLz2ErtT4ZaqnD8+SEMLISS>%6${Ba?XVkP*B08_C)l z5%%7IH~vO!`itzzNxJ^6j94|D+~Wcxrg9&-l7Hu=ZxTu`(jT?ifU*2KVx0j#JGq}+ zOGf22IZ2CwjI;s9SG*SuGU5dHr+Y>uV$g0QezE>`w@ViLyWE>C$wD*7Y^+PoLZQjb z*UEiiWpartSyv$Ia_tTGfRo7_mY8wqMHWP|5cn7W>}V$LwB~HgM>7sj%tHJge!mr2 zp-k>Ie{=3-a2A@^F=IV{#@M1PG*yykJVf_nlPq|w&c?=}%&OxavYA5`qF599e|g5) zg(`8=w2%)&oMa{$xxbGq<;OF%j9X=qijGzYx?+X#hEmzsfvjFj1y1}7pf^N=KD`1_ zi5!Lu4MhIufd6G;E}tI7S$ED+T&GvMZxnQMqo6&=IR$UJD{iD=OSTDh=Ckic9xP!% z0Svr`?7p3cVY|4V^LkOWfHMjY=-Bdd6zlO$lKg|c{L^mIca58z;C{|nS|-U8$m{L4 z!jR<(l(SXf__F}qIzlGCEB9Zs2V?bYx_n3YBYmt6yX!_{u8JP(>d~<69EE-S_1|@O zYM=?f9+=QXPcL-ebaebD9ao}0pj(FmJeosBt|PC5L&zAsE5P;5ZZe6^@^#FlTu|gJ z>DFyzxLs@cx$w8VtxzhxZwnjUYTAVe>t zmv;#{`DRhbc}E6gvJRj6(ZkJs)``&f#@c~MSbF)GfQIS!u`2c7PHp64T+pVcp3!xMTIAhjPE_`@z@o7qBo_jeKB{*E#~&|R*jDrM-4QaRtB zUbF^Q_~#n;11}XYv%Y^YIRL#62EcAe5PlEf`}1%xvTp^Ty>%3vx6_3@NQd&?+{at}CWeHu0|G~vL2bkyS7Hi@jtH2SS-d-HginUBV`$i{=SEM$2e%ypB~%i4)k z+txD8(^2jz$j)?gmDeR!*d3w3*ah^C>J;$c@w9?pPo{@`4(E(Ee$}8(@4+Z(O`ql^ z&Q$O->KD!RpZjWOuI1}z>rk^=6gto1esz}#x>o7f%Ht@i(1bUyIYYqL5`Hlc@-Yuz zrjV=DGDE5;56xE7IQN?3Ji;{RP{5{B&f72rJWf(Rt<@NPEXS@GM#C_KIJ6R2=$-LK#_|PZ$6MOCrj|}2IgLqQMpuu8IaeRUoa&bz9SUg z_0B20dyP?e-@2jj_8?zy{}OYL@(;=Oaz=X5jWWwVQL1X_vfONx;?}NcJ5h;Q^jBWu zeCWDfD*6SvDaW-jD!@}&D zE&QAwu?`YPH*rsLpIp1%vMyNa$oGUy(crdOe)N;#9| z#vBU|Dfrb^W_p&%urt5qv)UqedHtC=og6&ZjX?+fG2(ato}SVmCxdH6C|$=vye^t` zI6q&9*tO~@oWn9}^2jR$Ne@t4S!>?|1+5ZuZiVHcDHJR%LuZLT2o3Lh9I$j)0<^GZP zEM^m`nM}xBKqjssImSX}aJv_vbW;H;Jj%z${B|-iw50@EwGnl1&IjypmB#noq+$l= zCcaoB;U4EzYtTLT&?29PDexdO2pO6{OiBvGx5Y!?N*=XqX#n}}NSy!0dPVIhI5mvs zJa829Ogc0#HNkra-DBI+@N9+&SB98SnXj?oXL9eq@)%*rdyVE&InHu7 zrG?lZa^^m$jr5J8r_n|wEjwDIC+Ga;wzfj|RAzpdtl+kQv$dW)^(oE?aQ&K|lLp0N6K1VQM>f~@N+D-Ye? zlCSxZPwzxN0>e0$S(S5S9bDwcS=I$SRdne%N!=GtV))Tg4pn8A3Gc^G6|+wE-69QQ z%4Coyvlbo%;ZZjY?#>LvFfCtGrUnBiXmIWadCF^CPX|Py+$kNLnn$4v?@d4QKJa5j z6J8xjL-7*2vwb;JIyxQgxYww1AP;fncuZHw$JZRrmhC6oI6huFbxoA`enzQN!p!?* zy_Ci#N=|jo&~H;gUq=nkAu7aGAOki|iSKS&{861VO&MBr*g@vJGz{b4hv47qWR=fy zCTIrdhHSVOSJ3;%{qyzqX4s!M zZzAjc%^(Yo7^Qz@gY^H0HT3&QGO{R9<}FcT-aI7+4O7E3MG4ahI^(x-PHP{G|-s+WM zhDVCRJNK}{+jG9c`(c#A`_WEvX)AnVy9Ij1$ih@?<-P1!q6}@8C>^#P zmg@8|{J~zt;-g0Ca7=~26Y0=huY`Mq3O2vh7*pngjZ5er7{vJr+hs6tE&cFPi?MlO zoW0`fxM)ON+e9QcOoUG-W<6JB-qA+huXto(l$qSXE7q+G>5k`n^^NR(c!I*40x9q5 zQ}{kzBYV1lj$w^aRyZA$9Rm$Ac4@p^a56}PeVm`zpvI0KDwNA%rhvN}4r^4f=4UvX zeStO!VVvb+4`F#Y=bXY(E}K68mGmFJWM1O$L>%V5)x#pX_jx}zz919B=9>{a!;H?a zSwm0G!UBF?jk(8IOAeyt8in_1@~|zE6y9Fk2emv)7QZ6r6S(hCpU_L~y$ND9oH<&j z*+*HgLI&@Lmj}|RSzCo~PytqCVHapofoppgn{Z6o9}Xuwy0f=4uY4_M*;*RW@0Jnq zxdz-GO~!Gx8TC76;U+&fk13p4<8ht-gR^H|oDJy7wd(|5S7m;7Yw0?U{Qr2ye38G${K^ce2QMb`CZ z@_y3~amn<9pC29e1Ig$6 zHI;~nV%a^+2W_X3yX4PZPkyS_*!nV9e#xztJ{aRb&WOCyiB-99{?NX(9G%^p>zc&`ch7$R_!x!@-Be6W0v-+dx4Gd`@zxscd2Dbe7 z8Y7YYAqBUtf=1jb+o)Qfc|89~Nlnog{yn=feErAB|-~N})9A=7*DZkr+aMV(HI3 z{1sVWl)rz8h98QcrzI5+ zdEUKjSX;VQ{~^aNl2hY(dZrT3yCJ!VV19I!(L5e_9A@T4!lPd*UXRGd!MsNDeE%=$ z(uCKIk_gO6<@Eu%uwK?g2Czq$FwCDBrabSyr=o{TE;45~7n817!gE+t;rSRnG7U?g zkmt>@6VKve*)uo*6Bf}MSUC;Hp5W>%rR=HthbTl9L7ieMfOreV!xZaK~$uJOaXph&d+n2K?F z){^@-mtQS-zN`yCi)YMt9+`rwOLH-zc{9lwP%L*gGJpB+NGO9+;ocz+VJ&z(2N%jF z7eDOk9*MC@sm#zLCpe;!oUij+QWw+58WI7ACcNGrCvRxyEXN1_lJ2}OxOX@bnfCN| z@c3D4w38YBMKY6~N6n%LY*-+(_Q$xbkr*|L$NA1&&O6nWZ=(w3 zODlhLd$SeI2c)5259XdPbCC6~eoECCA9#^BJa#q}(Y(&bHEhoOy6+O}4dN;2WTstnC{#L9>a7lfP&#+t#boBnOa zgePU_dgOqN-O&=`tC9t1MQ&w2ePO@L(D_B2yddXtnmM7LR{=^1V^{DqH1F0v=@T2ho*}cFC zPy9on7-hg}TYA10mBFpfUa3vq=Nx@ub<&xOeJO+WZVN75ijz(J{*~>)=;UGG{()XI z@->Us#LM{(%%$xfhNouc+a_kh%ApMFr^U(FDo&i~3`OZVJpvzR&|j+XzDs_p?ksXu z?L!gY(|`?pyzfBraZ~q8{nO6KvI#}p>japlnQ<|l`M-MRQ!jOa+KKz$7YWQ1$Uujw z^cd2U_}1itZm0PC-t^f$ra!4SIiq>;(xSix%O3^fOpzWQlj()LWx>&7`^4{qGu~}s zw!#KI^UE?(y@J9!VqTmq^K!%l`ULw-B)@hu6FamPfc)v8GfwDVBN$sw>Tx zdi}=JgGql}@+k`roAyiHe$LpGO>Q*RfK$UV=-4mAmTIx0pXQ2V14D86sh&BK88|zJ zye&D$mGfNS(~WsjB?;)CVut$&3%u6GNxN3gi1!SEIhWo>9{(-LyY=qBU-I5MVm9-R zU$FPkWfA=c9q74J>Sb;&y^1<|=+2W*+?|2W#ieL)ley}<$gxTY+T7IR%=-+?>S)2w zeX;U#q7%k3S9$??&+8jFvwFO}7(&vz~NyHgkGWz~Ksluii7ivi55B0t#7-vS@U{nE0hGmfQ)q9S`L z?qbH>X=S)n6e|&JoH61E{fu|@7+RQtro+e^4&nL8dn+gMiS5{H*;y_VlgaaLRN# zL@RnTFUH5nz!+y#oD>2Zz7G|@XX17ly__R<%Vp-C`ArN(&x+(R-)7*CrOc5(v`?av zoKb#u2%H^QW8?eTqGuT%PD+plIv4C^j`??9$13xDi9Bk7P1yli8|sSRmSD~sGnY9y z6B*|$7;d*;YCAdO;NDPFU7$zErVQ4{$QM70lj@ExsMwR7CeJ(P8JRdo&e|;`PHe`y z;@>@?ND@7|?&0-qD7n|q2c*juSM=Qxj5$*cNN^;-yxxNDo%YK}cX}rWhG61#J;IJ= zaBkm%<|X^2i0A3ur6IUa-Y}pouiI)1o@&TxE_Eia5e&_9@|)YtIFMC_S$FqI#0^JG zzZi_sysj2bp;z=Eujhe#rA>|_W(*C%+EIF3<@@}!53eUj_RE7aE_mk?f+-*3IooB% z@d@-!wvCYohh4F97eC*n^gsU0z$JwR<;%y(Y0i#MA%{MpuO8YKnRI(tFrI!jkai|NTz6PTwuiJs-;wR4G`95u*_*fj_To!^w%k`)+%uIJ_ z8UE}MD~`O*&!(?)qm2PSczh0GZSlW;SZjqsad79Q=11y?@VEc_@BjY#|Nj1ef9Joy zTj$Gt&qv8(h5N}#Q#?G~S6BA5yEQU-!M%s)eWJ#t z4%N;`xn&GUQTMo#5*&O!*|~61$_l^9sfDk`rD%UAr98WFu4_5F$I0c^H1$07HYFwh zWB23_V{fF~O)l|jly=AS^hh_aO<&x-zK*(((&ypzGjPLvq-Eu@N3hE<7|0=+>T!a1v%e^6fBI3$bj86~(}y!>&1J@B?`C7ks6ty;=Koz#V*P$*RI|?1(!zW6obIPZ8=p}8vJZv*LoInG@{TUy_}exN#~QOIe&tg1#y;T( zabal78DPit%z2*9xlxxy)=rIBev5sTCPvKI&0bHw0RxwEwsax6#s~v!RxwLZXMj^% zGK*JgU#$_iHl-w9kS+*oPR-uOrRynV8Mq7ked{W~fmMTcUhkGpi4jMHcJO7hBoitBs7b zC}r#)9)d+}nD0?0v*}CRy3>m6ofTTJuQ;Hc6?T@lf^%xAjA3svO3$7HSYNMcjW0$E zIq=`o{Z*;NyII4bjRGM7)-Zllp#2vG=Qu6$h5d@#@nj$M7Mb+4R2&|#Uuh|o&txTM z`H-93!RO9VV8TQN4D5f`cA`&bY&rNhXMUp2ADw#yaW6qHTu~r`nX6R!l?K-n=v!p% z{Pi1p`k!cUne~T1KLo&sd{y1q^eD1cY`=hEBiBNl+Q0puEOHF$q35EFfaum?dHkV_ZcZa(MyKsc5Jz-?3@J)Ihu(xc#E7lozv zv6evH|;4e;HYq5Xql#czwSc4BGTgczLub^jf0rRFO(hp&M0o!|<=qP0lAel#vhFP{H ztlhKcGm|y@>3zsGPNqkPkH6ziUW?Ds}@`tR4G8f^gM)L$VY`B_E+-rF{pk4)YA*_ z;Z`1&-emUWI(j9J(E&N80FkrFK2D}@rw4oHITx9uhC+W?6L;HqK63@){*BWQ}(Z@yH{&trVkLI$}MlGLLwUPNFlv4gr zSBXzn%BY@BoXvI??HDK79_}Jd+BwMAMQ(DT#9o?oc9lo$(-oySiEoIb#LjS#4p&-> z-PiV#aJr4`dhRAWR=LZN55=(#7bg!KF_D=zd6pe;Nnj z_{9L`K9L>f_l`CSfTxOnM)eT*uG4V7QUfh}G9DW=Xl5OVHdY#}ZW4$wD*`cK3BRt& z^N#$(oI3Pku+J8uWG^z8wIc@&BqR_`#s=a|`2d_N7la23194(B|GvKlSE|q_Hb8?U zo0 znEOnJGd=nBUDn#jC5i|6$dCL!&&4>Nv!|LyVM!sqCEa=Mu=lv+OB7;Q$IB$gvNeQ% zH;L!vEczcy`SWmHERRnj??L_et;8J1=2y%msI^h<|F_jIUd^1Ne>v3BKjbgx2Y zk<9OR_6t*cr(+(^hr7GzYGhAyacDYbkblg&pN2he)A78X2?6Fbw97YP*PApL1DIzz zpFYP(IyhR=En~|bXlF9WuQ*rfV8Y=L`XD!^W6W4O(!LhpFLJx3^5K6D(%Uncp=o5V z?Hn1$7j%;HoC*4xhvy@iCC5L@38#-{0Qr`qdH8pI9+EuB0P`G-s!jjNJu<=Uu~yih z&l&D~%&SlLBU#106$;RgU$=GnfRF=ZhhFDnCv&Q6eJa4^HF=2Q_nu`j&!lr@uMs7q zz4YTEy&i2^>2+PVE=6^0PfD2Qg%rnSF)5R3W~Cgp)+N7PH#xjOFe7OczOQzkA0q}$HvQkdba<4k|@S7 zdP-K2O^izr7uPr$ra3GJhbD-wU6PDr?ZtsEn^_e%jIxBD#y4;EQm=)Pwdh3IQ9VI?`XtK73WsF0-6450Gf6&dWp9i>du4m0 z=vNpdrqOXJ;U2S3JtbPqArmv5dDF2fY|Kz&RCO0jt)pV@sw;NdxuMZn6+)Y-$%ZO% z%2tgRCLLl$=pw#U3?`T{%Z{-4)e# zt8jO<3L|T%@p%BV%JeGSo=8`CunKjnGV|Jpy`a6^zugXl`wQ;VioE5`Yg zgGLDN=_8q-MZwLGNqKH3wr$J~rS;pVAsLgfV=IdG%FW2CGAG&1@((iqijKp@xSnfE4ye5W`g7zBmvJ4)bKL{1XB^yC2V$T{-Z@K}#`D7U%G8b+P*Od(n zxc{D9B==zdeGRthC@uObWydxL@jj%I{9t?O-M~)9t*(-VT!&5U!ma@UIocETqdZ~T-xC2pJz!=t0nK?;KGq7u7_L>`y(L=16Z#&R zXv^`(>J1q=t_SX%Vo!QoW_Ehg#d@XyVSMi!m2m!T-d%deDdovqdWUaymyhh1`TMR? zW=S&7kM!={{V+9wLtMTwm>EJ^X8s2f8>^hraX@mkDxVD{ljO)O*o`~0ZB6grB z`f%=gaLo(jd2Mo*us@|~1T-3YdR^)Idq<8iAQP*(-ucffHJfvS%Vs^?MrC5<`XX!@ zQHb^ma-PZ}JXp!T3mbYP>-CaBm%GTo$(?0nLu)zmKq+VEDrNo&lN_DT_3uMElsPZ| zL3iY9U!x4$Jpuc+GB-5X6ZejK!pFpH?h1E$1H*CgGIP}yhSTjIhRIRkC~n2;!+SKf zZzk$A$;7kROw3%Ii8NobGY`0yT1`G>E9VJaA>7|HN0i^YTVf}nL#(CjM<-dlxtmPB z-9rwwvnB^(lEs6oBdOR7CeA3+%*|l&+$e8uc%YY_b3GZ$M;0DvobAaPpcj5WLhl#n z$O1AUuQ!Atnd{JVrR>>hk%=2z7Y<#MiS|3WMl{bv8F`*R2XIa~QGg$_il8{mIb?Ma ze7dpDukFVER0ruZStU1W^EtYpl9cu;3BFb(a-UA~6=8Um&3v)1%u6Td)Mh-_v`(31 zKgh*?F2shpg$QiV4AIH-TD>lW`SAiQe3u~ZsfjXw0=>H&!;5bwN&ECT86D_=OLPE@ zUa!K7cS@vGC{gc&13C@}z~mi)$R5S9EGH2Di^*ef?;IVY#npf5V=Q7H-&_qoa(o-J zkvRfU2H3R9#qVS2dYwY=e`}5#+FbPKS^4oM3U!8-nY`o-nq(`~vR0v<^GgzQN|L0f zxkgrmC5s=uz)P%>B=?FVUM^Q5aIq4NhC85Xej$s^=CUrMpkCy#<>zI{UMfPlhLhawt zOnrWeLOtd_om)2)>ib`kC47KZz+Ql96B6X3w^sHflke~Eh#ogMf8{w~$!)p_SE%6Y zt3n%&?RB4%FYw|xAI923SP-1Z5N?g-_&XyB-4^gOSu?lcz6SN*(6{vqGnBvOV9hQ1 z8Ln`A^fTaCqa3W_pRJ}p>VYHKi+&3Ao^o;+hZO1-YZ64wzJtrH$%4?~w3EI_^V4xM zt_l5vEgexWUx|i=N@&QR`cGHkY9{lyQv&Jp2|&Uto{=mddqGC!YNsTG-_+vYM@i6c zOo9jR-Am3B$&!nynjE+W8W1zYfV_DIZ2L0@Z^;in?XOTz9;i^aB8xFNi7rAqr6$)o zC8s)TrPh9pNVHa3F%#q;*JQb5uEHCI5(~bNBiyURRPQd($0%WUH;}tb)?RK0BH$UF zWXAd^AAXY1Yy z^`@N)wQmaRw&xV;_3N1-IzLh7Ha#UN&61>WqE-U>$B27@M(n4l;2Fz)hduV#USN-T ze2%Wnutz)2|2|pF==?hn+r|fAKiJd28qQ44wW&Vr7wE#e%5+|%i|i3yLRa!~&S@*j z-A^`P1ZyXM@;MsnWI)_wg}OVL5Yun;R*qGuGnXsW)^xU=e$ZLE2C8JSuB$A&++D^E zR!UrLNBMljBnmK ztHZJAd78Zxy-~^E7dZ~ScaZ)8U0K_+mwRH8gx<_`er$%=Nw&7_e;G$^X5s1=%_j=D-7v$hI@Njp$o=%% z3D`jX-GSU^!8doDSnr7|4LqQs;W&2xY(kr6JtLy*uFL3Qa9@la?uSak4u(h}^Qx%~-dnlf0*r)X+ zRT`xx$m3V^>PbAWO@hR8uW;d>62ps`-gWm%+nB9O3;Xo}MYvrO(4%gpb z=_g_R^>uFp#&E2jZas8f7!~pg6`TE&CJy6ILBX) zO_1dmQe^(ec-gr-Nm_5#irEV?1>=;M+nBv?85+;!!+-;tO#(Oka*;0#>ZCTU)VSuGI`{?z|Q|1`m@=y*lS{3Sv zt?11qlfRDhMh;m^>vd#M|4EW{os;EeH4XXqBw1GX4+-0!C=E0Y7`B+_8@Bd%)RTKk zGL5|(Fb{wnW8Mw!0du(q()%OQA`sql*w3+BgExBveLp#{fKkvu89iu_hzZGikS#M*w0a?XQFs> z&z@YOmHwR^Fgcf=hfzw@e`OC%7iJiQsxbOT04^j1BDr%AmTwQj`z<`1XvBSMH7zbL z*P^Bw^P2eFT>Hv>W3mP#V+;u3XZo97YT;*ky`KK#RXKE(Db$Jl3|m|j>VenDesV2l z#Yc1yFh8DeY!^;cok*$}3tI6~p?zNCy|5BMdXaXYd(K|Ms{>1(TI7Qy= z*2VAg*_{3|=TPjN#rn@h@{C@V;-oE;>L2Mri=fBNoF3Lk`6!!WAr0vHy4l1X?T3e= z7X52;m~X3eX)O8V5U=RmVA6-;%n%)HbLbsw-c(%X{*YJ9an>ye#aI5GKPTm*@>@qK z@F^mOWRyA`F#k= zn~_^Qz&vYbE4g#ER9-)EgH1^YB3oqOMpNbm&#)4;S(!Zi#5~_sA<(LHh})TmgZ0{w z(=C;YeO&o>55=w3{QPb5v1vj_$)(rq20fA&28AMo{LW0Pd|VjVMzlFUWl!mNY@ZQ| zKi26mmfzpIy_M{#&D_L{{WF*`n~$4;?WO0WN=aMJ+*scbyxfz42SW?kci3KP-~B1$quenp zAQajytG|x`QluiYx z_D@TBv!zV#UUNex_tuqnbeJ2P2bZty#4n~)UM(WOc_b9>>oZUiTL8n`Hj=rhR1Pyo z_zZbK$8sHNt)X*wcMJKZG>WDB1ZFRWV*fgFdDRQhq*rsf)3QqX)5{i5zBT$jxzX|D zJ-@e-4%^CQTO)VmKc?rg7kQ<}c^G%Cl~f)tku<#vR+3xP|J0$$bzaXAE#zxdg+w3Y z_2K>9-IKY%Va!M>q&M)FD!E$U4Qbm$(cl?5xVCxB=V>879xHeb#(wi|p)gZt;6hnG z!h+h0KkLeiCb_{jC=^Qzb+|-NVsa-7c@bJF)A-!FaBVi1&xs$setU;n$evlH67|Lv z3x8v-^xv#`{*ecJuXb{O2%k4z=Zk$p(cDjmUZa_lJE6IF`d3PmnJ&otH57GvGgtSo zeDoyOIX(HO^me0va2oT?2V`I`dBa`{n$a^;BHQM><3MZfOCRYF@HQWdhFQvc@@1cr z-Ep!uuTQEDYmNEnIG*31_f3WkoPZDSLZJMl9`0%D!IZpowv+aEH&o$5(Qf zpRA;k{GiuS=0X2Xj&*eg@^~HElILAfy-HdIx#CZr6%9{kem(2DCFp6jEFvYO|CFK56!z<*xmn(bw z$V(~v^fKc5U^ zD_L-;Qqmi`Lwg_uU!Uo4rF%X`S+tRx4S&e_!){2~Ob&5eIu`8U@44DReDg~sw9pN| ztqI1{Z{#{T9(KIfM&8dV6RTEkyjP)k#_KaCyZ}d-PyNfy3VCpp`R}Vj;a!9K6LQwG zw=@=+`%|9noq*(Y=A?6++&48J6Tdc<5b~JK`qA6lj``6CbZCBw-q+<2gy@h1we3y}pT+xSIw)(LSi=WdI+PJj@fBGpsFS@~b96gnsrw+7Y zj?=0*(bG?Nn|uoBt$Q~r8?{1>%qobKSBGs;*OMN=iwP+2OP^o_y?ftI%ChxzX*0KU z!TJRBbSk6CzSZNk;482Q%91}_Krqt-ogF&nZmZGjP&PsB)@NzA=Hy@7q6{Qar)%Dt_^ z+T$m zvKBL@PTA8-@6Qa*L}WB$e)oAJ5{5^URk26hC1!QzkvIIFg^f`r6wE&%zc;qUYkxnq zp?`Dm*lY~(HPMM2D|3F>ApV>$x-8P*9M`i?xo)&{j+OLjHn3U8vjhH~#tZrVmquhv zBRliS8tuu+ZnoB-n?*Jzg_)o)h$X*l&)zM1+{PwC9`NtA&V*gHnOEDw78`E)qUKxr z^_V04Jlx1W_7h^A&ihCnP|JMV4M&*=-Q9%m^u!&e$Fp;cANp@6hedwF+fJblJ)a<6 z;kMXr>5Eh3w(d4z4s|yZq;a&=)Y@U}6@RQrqc?L;7NXu5@nzOAiQ7a^Ty^S;tD=1r(bd+dwDN%7tzcJuL;McK~r+RgZH+%bn%DP5;`cB(f=^igmujIem0la;W+)3JvFG%XVH~oV#Y+Yy!Exk!@54u zmeFf@F$?pXnvmNqQc|+XSVj9_O>839{n>bU+K6H4vC@Fa)wjMN=z1OJ!gsShNe>j(0uf0z(|EI|tD*kjlfU*z%c z`)BPO{5#f!&<@dZj^E#Zf#W23-fk!8)#Y>8NEs&!_*`w;&F}L%4Dt9c&zgMe&Uo3~ z#)e)Te|#O6fbHG+d9IppGBsM>IN37a#1CW0^O~me{S7wZ{^2NTV`jr_4qv=ln}9<# zaxf`}UeP{rqF!u^zgzlZ9?$3c)*wghVZ^DdXmKQmK4*tNoUbH6YskW)eI_W6B*>w6 zT_0%;`=bZ@V@d$?vLgW%x;P{APpNPkhPPCSqn_ zHj3XHu_h=+4viwWUW4O&3g;J&Z(CCT|NV^fe{3DN*U~CIa8prQNX!_g)CHl=>BI8U zGoCba-qWKhJ#NGKbj3u4Zlm{{^oz|-rCn^kGCj6MaN71iU#D9-P1QZC`OW!9N<@0j z=vB_6A8b!g+-{wI?(GgI|E7(dtM5s3-k4~WzOb~hbHl^!(yiz1PT!Ms$EkPht+YW? zR-_mD9!RToe$=4y+E(eB&8yQ*Rnh62<|Iisez_MX%Z3LDa>`sQ(f`JabHjL9;=*TV zCiA3w#misr$>N!wC~ar4W-&EZtY5{+t;wvb&}VyiTat`4Pm~z;jxHILEUj7hJ^V;3 zE!w1r`ec%Xm&Qu%^BOVtp?}~}igZ20Il?Jfj?l}P$KKcc(Mj^;gI0EJ)X0!Dd(`5& zvWj)$&sGj_Tx*Z%kL=NLs{@{Grz^lmg%4j@&u+%LaXd2z-5v1ip*>*ffOokn^ir#! zIH_b7HGiI7fyO;m_&HpODJu3v-e+HJq&*hsc#a)J?s1L^s~f3sfc5#@mG&^>*@1!o zO(!0pL|Kaxm z*x8il**pXJRG)o~O@gpy66@Hk^?O;f{(nCZgP#Q;BR&8I6KmTGSp%CEgdxuZutY;9 z(uU^)|M;Vc1j6dGKay?+U=n}-71k0C_n>d!8}lc~3_nz9Fe!~==1483AJ<~|Ff9&r zWNt?X*6W`!k6Nci!l)z^E}{qEr3U`f=-~0-dA73#<0~{+#53tg2Ra;j(%+M=g<=MM z*!;cScwXI@XEgOvHHg}##lyzzC+5#?8lnLX(%Be9SH=K3f>-iFsNwE2MdIT+8H+Rwk~rB3I&JI8?Q`8kMV-7jtw>ukkv+DGITC z=GV8EIZ7LuMdN+WC6!p@E9H+<4sxrTqm=zr$|&Eiq8Qv&j1G=sJEezw$?YnqqwOX9 zjICVn)msj>u$QG5nXB8Oy`*%v5vxN=IX2c-e6OgOziuxf?dfkkY=)+{E2VBbGdK@4 ziG5I|9I`OU!lMeLvQF&!O2KuN0#j}1q+eAbdlpn1ABQOfM?O$>+$QPH@=?qfZ{3LF|#J1{209e zA3X5uH}X^8=$YHdI)4*S*04Qs@-GjJ9>5-XGFF8TJ=ovF9P0fO(Cu#zSd(p3O`@mn zEzbyM@a*>T1oXP^fyh+;8J)ba=CTK3i#_nUS{Tm140v7z4(OPndN}fxw z)?GeM4<|AJs$F`_Q1Cp*s7FCfy5B4_;d3+-H8<;_cW0eEUys9{dYZ3=!n|gHbm5KiP3}*PUE~d;t=>$3#SL)#q$9`Hba$UXk7@R@x#2MyAP1fW7YCY0T z%;Y`F%<4^gtlP@-nbC##I;0RD=7p%bT8Q2{@=teouHB>%ezObk-oTs%o>eIKk(D@4 zo+`V5{RV|dj4yyW&v<@V@q8tj4mh4;+;u60B7_;2WEe8Hk=0^PY{N{Rb2MO0zkvCL zEei22x)3k76yomW*AqOq?qe$pGVR5GPJ5|t<0$ikI!mhyw$fQ_ z<>OXsW?pm@(-d2|+m$X}AF?W=QjA7adkg-Earl_j@PVZ&1p@SB`Sj z&`s*S?kcX#b?_~$jB>@?C@Yp5B`&BM8hlkCd7=X2=yzCFsldfd{@fP@ zdS0)R1y8D>wqKRpyQ;urf0G2|Gq19`N%F>#AxTsq#-9J1`7?_iC}78Pl_RW41^+Ng zi+qz{0yEw0s=@cW0=?cUkl48z4nOC6Gn?mg*@iIEKi&t>51Eg^dl`M2ie36^MxNUps270|8~6^f4)9_@I98Au zJ~%53lYZyB!}rQm%>Ht+l2=wT7siX{Nc_s_Mn~#d=7sQmHfzSd^vE#yC(+r+Gt#>J za}`#4c=3JOxre@&s7$5;y}4wET^;G^C}b^XND=2?GKdN~xds-( z@+8ko=M`Zk-z%@m0(?15#&;9_jw|WMn#$bGxrOL-oDN58x)+xfVm{y1@iBCv@Ew}B zoea|gx@~F}p@e67mI?GZ7V`buRD>O+1u%Xo;JT#{-|k*_o|bW9VBO&6=@uR8JHHun zByC_F!@y~c&ZgH-YOA}kC&Ot(<&pHt`EI(XBMRpX|L}DEb?5Z>8iSqoZg1q=t;Q!O zyFT8RzFpYoJbPtWTD$Ci>FdAkciQ}_{F2uYf9KYk>gfYJ9Zox%G%9`D=OMq*VOs9`y%hOmf+|`O< zxmJ`#@nTMI;~!5GWNPa;$@q{UpRQ=6-h7P&ZcP#U+wl?_c}hA}Xl0)&LGJuZ-%@_E zlov3Un!Ph``y|Pmg^4nL(kV&oLD%C&t!xX^%9bq&($$6T?!)8I6JTp#DP5(_L$YL>``sBBWCwf@f?(H@N`Gy zUsED^x&!)hU3sFw5&r&kh_|MTX}3T0y~r=-kuhu&gmwGrA9=})XtFqwYq^fQ#@-dy zLSB0DpDxV53}7a7EL~E+(A6}NEaYm|Nw~+D7{T+a!Ss`5(B;&EXKZ5v@k$+p20sH3 zcZJ>;{_N`kK}g`*v-NWJyIc;y7p_T9dj()@IrGWP=mFU1Q*yrbwgfXA#h>Fu-V>vm;Yz0P6=UG;L>ENo%bJ3YvtaRbm5G_{h zC(~HWUX~rq)vL`MJDzblMY7+`itD{o^fYp<_heBH(rfbE($|1a^$hss9na?avqyNm z0opuf@m(d zfXnC~K&J5xbB#V{Ad+Lzu}*q4I8=y=TFmL3S%~S&3sKXO^LWD|EX%Qz_AQn2u)n<= zZrELJj$XoRBBNy|>)UpfgkpPH^Q61ny5cCNFZSYc$Bb^@>WF_qZ{-=2jH;`ELyS>I zWqBd~E`3rzJ>WFJ3#I2gVKjK6zkfJ;%EM97Cmi+2HvU*kkMCkKbBF249YIcJeI}Ov zP39r+GSubt^rjVI4zG>#u0k}NRES*xMRb;a!WHMPQvbfa?7Q7v+?V#0_j#R}wc1r~ znbSF_GsEOo3j8FCdh;yvmFJKR`Rs`V_6amN?1=~?Gudi+B4v%||EwqNC(=t?7KUw) z>Hj)MkEKmG{^VL~ds-&04x$@)K_*OOL_V>P_H$+der*WxS9aFY3$L&uxpw0Pmm9WQ(=;XLk1 zk7Ylys1rO9Jv$6_GU=_H5QZ6Ck7gBx<4d=7IL32?iL{ROd(o36~LmGqbwZMLzb;j%IBdyrCWQI94c^>plCCEI&X%BE33q& zhee1CaaiFUgLfk!}=NjXMjTbaM*%QHgbbV78mLn9cG+~IC8itnlxfa+> z|M6%&ZXBi)jnB~F1DP;O)nkV_9hzLD_Bu;0mupKK&X?KkituByMsD~g%Rez>2cxud zwMr{RZ8VaT$Ns`oDkRrdA*Glsn4c2;*Q&68FkQ9Z$;5>PVdH`TWVH-Lg9m}=dWXGq z9B&rQ(V+JS4K{bz!d=K2jLpT~rUs1OnFEVw20Ru6{$SSg;Qh>2G$_=I9L&@jo~5g1 zk}bH){`iZ@ViTP#O~^C;Rlw}deTg!5kVc{xtMKv^^QNb&pdP0}&N=ezI(t+MCF?Md zJ?%RKvGx%A6ggghnoaIuJe{;@T2ww~AK`2*R<9;+N#-E?qyZDi$VK)sVD)ALT@tyN zP@Ic-%uoL5&A#_Ug}Q^cnfd^|Tb|6!w5^#eNzCbVd7+`_kB-K*%(k$Mmkq3WDF5>f zdO2ckA$u&JaGtBdyyp_KohkG&HV#6@D7vI}1R`%~AY6arp8T5@rCA);pR;eVDL>m` zEjraP!0JX0mT^qA=)$~%6S+Jmp*N`;U6BVA>QW7Jo<}gZlZ?v6(PnDr2T8K!c#1gC z1GeifKMUPo+nrLSTYdJIrZU5VETf!bmgzrTQ17@BBAvDHeqGx4H4#$44O8i`ES$VGb5?%i=fljZgZYp+CDi3&r>fNuQ| zh!LEFZ8#SnUlE8uKL(com=O&fR`xpaV zA)HI@(2bv9)FrlCD}@Ur9xfN*-Y&->y#AqN|Zo)CEQIKDXW<%zL6UFP0Jcn zA9|dt+2imlB?kSfL{2Le`p*c$x2J)a9~ubH1_7w;69|=65Dc!&)=;tEfKJan%gLqK zlCNCPet@?I*w!+j*Ec#V`FUEPE*=90JneY85Jq|P|LOR#L z_um)5n|sSnYYNd+$YR1=3e^M5%SaAr!I*s!m;6;zZ!hRIy>q3$zEE2c9g<3-DO9E z-qORri~JR-z=SIbx&X*DZdc&I0)DQm3iP$|f_^AJ2j{L|!kJ&3=??#|^yzcoq&fhVTb zqLVR%{iS&xnAC6*qBwV*`N{mxap5p8q4WL#uhn(t8*)xJ>z0X+LF6m>&mZU6yReqr z`QReFp2of@&SAHovuBDuR9kJyq6T-BX=7C4b=E;f`1F(-t8HXVGe`E7SBD3x;csSx zA6Q|AR*TGV@Od@V;~sS1HV;%+dm`tm2mZZCmT-nARt^qFx3Szex`$z+MK~s&V_zJ3 z)CqMnv27?_zB}}oevb8#0zI}Bb8l9`9?5fs_|$`Sg^WVjb)bKFD*cSryGaX=E)u45 z6zO0mbFV7pX-)PU|6!8Sbw;sfy{pwe_VdOX#lS2Dmt0Sn|HdA{treY`#+!?C&sGs|n~@#4517i+Ok?tmUieKWCwpRLBbLiEVwzV2Wl z0QR)yvVUP5uUYpLX>OG$JsxXic#uY>o{N`X_oawW8SBWLC*+a}Z(led;krFt4oXD! z3qnMTAS_goq2@b3c5x8Cer26FgEdypTb8f2_)PDMYYcnJxi0oGvOi~C4)mMJr1i^% zc~%b27BT0UoZj^qh1&3t%<_E`_mXC6S7s`2*qKOvIzjquO%lI#$)ao>FLPKoAGnog ztx6TP=5o*SL50Eh9Z^1BiRnQB+=BL+B`Ub#rWB_(?|4T7=~)U$STj{Pl3 zMm*69GqA+%Sd#QVn8;i*tz6&hfRNYh3#j1UYAmnQXFIfAt;C&QgRuJmJ&^%q81InT z1LyfHj@6D@6#mqr!vrmQ$I|Kkl>3rxNoc;!z+S8zSo5E8uUIoK%f({ypWiCTo7083 z;G04nd`O|zJW;4KACW2ioFpDONz!HZDM@XYET^NAq_TdpqzrSw-JvS1w@@LE=L$c| z>C)}tz#K9<2jjSZ;vQ{udLT*z1Mwm}2)4g#@!U;|9sEk2lLWiANm%qvgRu(kUFMLd zTw_4kW4hpbaZY8Q{kVk+bus-xy{nt4eYwtX{Hai)aIw8 z`MVVP(998%2n6G5t*aic$iwziJ&-tqn`~AlmkQiWq8GXyKrxa>svO-<9m|ovA3UvbK z_?u@E#r#T=MAJv{&@5Sc=f=vx1xeDOM^{Yb^BZi=41?=R`2Ix~gtrQF`UIivSgv`h zabL@G2+N`X4CX#m-+-A+g&G`vNG|`a1~a%mn^Zt9wnh%>{KNd~Xl6_Y(7${>2k-V7 z@E7OuK=uZ#B8O^|&;QLizUm$S`G5M#7Cmn*_7&waVuTw`HVDNDwGIa&3g{?qCD)ez zkf(tzm~P2hFnO-Y|B@@LYc78=hp1W<^MxPKi+4N&Jx7o?iEbo0&de8X=8CbAA!J`O zaC;v6v(?RIZQJiMYqC2ED?_nlw+_~!1yCMpB^}j2rA0&XJAVYjvXLHBg2^RqvXqxe z6%s#^yxW;z6fM=^tu7z?+gQrR=H;UL;DT~Z2u>NvLv7DTMvFG`g88r?tlhD5YzT6X zq$BG&y<->2VKF<&a=Hq!Q3(09z zB4NzoJuoce||B!o)w{Zl*pXu0r{A@ubo)d{V9Q?-B3qIo@>Z| zc_aB~f7(KpEGw0+aV~Uev5$BP^II3^BmFtKysKpr)R7*{k>n!l>oD#*J$H!>rN@zP zGStTv_lI-un5V-$a#(F=TgkVRrF1>g)7LD7``rv2<8>aHMGh#aLi&}v0)3b-Jd=LC zsQ|nM@z(ieTo|4zkeUeTxFjENLeT&VQFVyl&6UL!g?Q0q@uOSZ&`*Iu9-r zgP!+yZWxvXWx#wHIacrXqT5j^*QU_-Ff0U$_UzvxzxF8JLUu)zNbxZ~hi^l0X@5GN zEg_$k+C+-7OJuph1?`JMaFw-7wH@!TzP&h1E|;e*-SA^}DBh97ayZKSmEM9GVL#=8 zxMGe)DB>!0C>>USX!;h-pH)ixTJ%-FBe(040ayP1?|)fJ{nmUh_<7uHLa{iPT%J=t z4)wE;9hK#xadE|XK8H?&=-KQ+FXXOvQnvPo_%a84RCU&CU+It?mXEY|%_M~U;Q56v z5Z=e9yuZ&j@OiLmD?WcPHz3socdCN1^q~%p6?x1MpvRLr@2Y(Mp4lNlFu6;I0z6&Y zLh5uV72O9n%#0?Nx`!1X3xFTZ% z{eyfCTb$0v)B7D{pl6wc@V)a42*J%T9o;G9XX`hYYOl&<8M)56iHT!)fc`LJkW zA>a4?l;cZW*%uswu1Y?K76nL2wGe~%cTs$!kCohavspUyO=E6*{T5Q$ieAwHE*QZ3 zHK1Dt8u2;#`pimBxK&6QbFuX!L-5ujgSo&3xX4`fho0Z%Qw=wGKMg@oa^-0?3-Gpc zGx=n!l;~|PxXE!TEmnsNa+JSaYfBGysf7IMib8UW4?B=6pH83b*iJI`LaF#H8;6rK zLNSz_=E)j719)~qru*Ar@2d@H=a`7ef%NE2GU4FESb0=rjn-#;;Ow4={+`Th&LU5@ zHd5{_vO%99AFd@5(6b#KJ>>rU_eDuI`KBw|0}&dZh;a$oP`oi>L&OPb{mmY$-;m2= zO?HfT7B21~514yGjt{iO8s?b}dY6Dfi?b1Nk(}L}IH~EuTwQW`_y3AV6LM!~4w|r| zUbLjA*kPQjAN#`-Vc8)Y!Do#~nHVW5yduZLtrsdnBS(em1ipjr7YzNl!}~^e|(d^5uB^z9$>Qt{GAB zYmBT2vBu0dKDb|*fZxwQ#5?kaj-~O^ z9C@xWEy*R#GGcgmtUQjl#l|{*So1Ie`+AcznruXmFDGT_7v^8jA=h&-0aq?$VIV)x zP48oJ|FjK8P4ht+xzSNKbKpTfD`z|NyZ4bdyvbbMA@pYYXW`Hh6FR%c$mh@2^c4DI zbO?J4BeM|9>pbvYv@F=h`+Lt1e|od#{UjTg_Lx|kkCA(scDQ?B12RGq@xYC|LVFYL zS;a^n7hCk1v;ptVCh(jm3tPLN_-pTqQ%)kCCM#9Riah>M? zD|{2sdVLl;yfWhBwP@)|o^<Ybw8KeRLbunWRGvFnC!*$tEGRyZ zd&-KHLvNWAO>U&eUkUiUnf&QE6VmEOi4F6VBZiVMo1K7vR%bEm*8~r8ZSKtJzOdE@ zwO1#gY%;x&{BzGFMN0v>zp_()XwokcK7RC1)ns3=f&5^o4bM(|@R*!b5qY#b+nB#R zGD=E%vX^ra^K*-t4a&dQkLyNQ^d+Zx$QC;m`XN3#f%~K!JRV@g_c~FM;bI5x&i+`$ z>lwI+Tw9J2-c#eGjDPOC{0(@0Gy#EmS?m#IZuR;Y+4jN)2J&AIxqmv?HwTJcMs$)` z8A@*SSdkBVM-otDeGX=?Gor)2C>fSwgJXkykvKIG?!J7^la1KZ>$ps!7xLaLKinM2 z=Qfet-$WC(I7N!jB0Dth=8qC`m&xS&tfI+#21LrY-)%6kg+D(1O5dn18|$B$aEhML zPxL}Q*hSysjRagP&qCwlCcKywCGY9WdvMAZ6IJAJBgujCd2<>RCy&nAqEYY$JpUts zPM0iP{l$c3+DNIk+ZKDmeKF0FT%dVMW zlB1lH>WkD93Cxt`bIa$g7yIqPnRo2;m3hs)?{n^v=lyQN(LbZ*G(Cgvdwkj3oQOT- z?0&R0K|4KG_8M%+j_~^LOhCJJ~esvegDX&-uX1kbwLHe6I4C zul+butnS(%uFxMotrF3b?{9;P^j#X`Wbj+wuUKE`cpYk!v!2nCwZ;e0;>PjZa{LAq z%}>Pkt64bw$%wS%XsK&qi~5QFP~Ru#+lKkS_UN_Hhpy~+j!juGe{94vn^^hT(iUc~{or#V5g)r}ntimestep != update->beginstep){ fdrag[0] = gamma1*gjffac*v[i][0]; fdrag[1] = gamma1*gjffac*v[i][1]; fdrag[2] = gamma1*gjffac*v[i][2]; } + else if (Tp_GJF && update->ntimestep == update->beginstep){ + fdrag[0] = 0.0; + fdrag[1] = 0.0; + fdrag[2] = 0.0; + } flangevin[i][0] = fdrag[0] + fran[0]; flangevin[i][1] = fdrag[1] + fran[1]; flangevin[i][2] = fdrag[2] + fran[2]; From f0679cff6d87b0133f05833309af9c5d44468a0f Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 23 Jul 2019 09:27:15 -0600 Subject: [PATCH 062/557] Commit JT 072319 - added 2 oso examples in examples/SPIN/spinmin - added doc for oso_cg and oso_lbfgs --- doc/src/lammps.book | 1 + doc/src/min_modify.txt | 22 +++++++-- doc/src/min_spin.txt | 36 +++++++++++++-- doc/src/min_style.txt | 19 +++++++- doc/src/minimize.txt | 3 +- doc/src/neb_spin.txt | 6 ++- doc/src/pair_spin_dipole.txt | 5 +- examples/SPIN/spinmin/in.spinmin_cg.bfo | 54 ++++++++++++++++++++++ examples/SPIN/spinmin/in.spinmin_lbfgs.bfo | 54 ++++++++++++++++++++++ src/SPIN/min_spin.cpp | 4 +- src/SPIN/min_spin_oso_cg.cpp | 12 ++--- src/SPIN/min_spin_oso_lbfgs.cpp | 16 +++---- 12 files changed, 200 insertions(+), 32 deletions(-) create mode 100644 examples/SPIN/spinmin/in.spinmin_cg.bfo create mode 100644 examples/SPIN/spinmin/in.spinmin_lbfgs.bfo diff --git a/doc/src/lammps.book b/doc/src/lammps.book index 2738c9b051..8abe9cffa1 100644 --- a/doc/src/lammps.book +++ b/doc/src/lammps.book @@ -647,6 +647,7 @@ pair_sph_lj.html pair_sph_rhosum.html pair_sph_taitwater.html pair_sph_taitwater_morris.html +pair_spin_dipole.html pair_spin_dmi.html pair_spin_exchange.html pair_spin_magelec.html diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index d342e8bf01..da7b593d16 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -13,11 +13,11 @@ min_modify command :h3 min_modify keyword values ... :pre one or more keyword/value pairs may be listed :ulb,l -keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} +keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} or {spin_cubic} or {spin_none} {dmax} value = max max = maximum distance for line search to move (distance units) - {line} value = {backtrack} or {quadratic} or {forcezero} - backtrack,quadratic,forcezero = style of linesearch to use + {line} value = {backtrack} or {quadratic} or {forcezero} or {spin_cubic} or {spin_none} + backtrack,quadratic,forcezero,spin_cubic,spin_none = style of linesearch to use {alpha_damp} value = damping damping = fictitious Gilbert damping for spin minimization (adim) {discrete_factor} value = factor @@ -80,7 +80,21 @@ See "min_spin"_min_spin.html for more information about those quantities. Default values are {alpha_damp} = 1.0 and {discrete_factor} = 10.0. -[Restrictions:] none +The choice of a line search algorithm for the {spin_oso_cg} and +{spin_oso_lbfgs} can be specified via the {line} keyword. +The {spin_cubic} and {spin_none} only make sense when those two +when one of those two minimization styles is declared. + +The {spin_cubic} keyword activates the line search procedure when +the {spin_oso_cg} algorithm is used. + +The {spin_none} keyword deactivates the line search procedure when +the {spin_oso_lbfgs} algorithm is used. + +[Restrictions:] The line search procedure of styles +{spin_oso_cg} and {spin_oso_lbfgs} cannot be used for magnetic +NEB calculations. See "neb/spin"_neb_spin.html for more +explanation. [Related commands:] diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 890e324aca..6883a4197c 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -6,14 +6,19 @@ :line min_style spin command :h3 +min_style spin_oso_cg command :h3 +min_style spin_oso_lbfgs command :h3 [Syntax:] -min_style spin :pre +min_style spin +min_style spin_oso_cg +min_style spin_oso_lbfgs :pre [Examples:] -min_style spin :pre +min_style spin_oso_lbfgs +min_modify discrete_factor 10.0 line_search 0 :pre [Description:] @@ -46,9 +51,29 @@ definition of this timestep. {discrete_factor} can be defined with the "min_modify"_min_modify.html command. -NOTE: The {spin} style replaces the force tolerance by a torque +Style {spin_oso_cg} defines an orthogonal spin optimization +(OSO) combined to a conjugate gradient (CG) algorithm. +The "min_modify"_min_modify.html command can be used to +couple the {spin_oso_cg} to a line search procedure, and to modify the +discretization factor {discrete_factor}. + +Style {spin_oso_lbfgs} defines an orthogonal spin optimization +(OSO) combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno +(LBFGS) algorithm. +By default, style {spin_oso_lbfgs} uses a line search procedure. +The "min_modify"_min_modify.html command can be used to +deactivate the line search procedure. + +For more information about styles {spin_oso_cg} and {spin_oso_lbfgs}, +see their implementation reported in "(Ivanov)"_#Ivanov1. + +NOTE: All the {spin} styles replace the force tolerance by a torque tolerance. See "minimize"_minimize.html for more explanation. +NOTE: The {spin_oso_cg} and {spin_oso_lbfgs} styles can be used +for magnetic NEB calculations only if the line search procedure +is deactivated. See "neb/spin"_neb_spin.html for more explanation. + [Restrictions:] This minimization procedure is only applied to spin degrees of @@ -63,3 +88,8 @@ freedom for a frozen lattice configuration. The option defaults are {alpha_damp} = 1.0 and {discrete_factor} = 10.0. + +:line + +:link(Ivanov1) +[(Ivanov)] Ivanov, Uzdin, Jonsson. arXiv preprint arXiv:1904.02669, (2019). diff --git a/doc/src/min_style.txt b/doc/src/min_style.txt index c46c1492b4..081ec17889 100644 --- a/doc/src/min_style.txt +++ b/doc/src/min_style.txt @@ -11,7 +11,8 @@ min_style command :h3 min_style style :pre -style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} :ul +style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} +or {spin_oso_cg} or {spin_oso_lbfgs} :ul [Examples:] @@ -64,11 +65,25 @@ a minimization. Style {spin} is a damped spin dynamics with an adaptive timestep. -See the "min/spin"_min_spin.html doc page for more information. + +Style {spin_oso_cg} uses an orthogonal spin optimization (OSO) +combined to a conjugate gradient (CG) approach to minimize spin +configurations. + +Style {spin_oso_lbfgs} uses an orthogonal spin optimization (OSO) +combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno +(LBFGS) approach to minimize spin configurations. + +See the "min/spin"_min_spin.html doc page for more information +about the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles. Either the {quickmin} and {fire} styles are useful in the context of nudged elastic band (NEB) calculations via the "neb"_neb.html command. +Either the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles are useful +in the context of magnetic geodesic nudged elastic band (GNEB) calculations +via the "neb/spin"_neb_spin.html command. + NOTE: The damped dynamic minimizers use whatever timestep you have defined via the "timestep"_timestep.html command. Often they will converge more quickly if you use a timestep about 10x larger than you diff --git a/doc/src/minimize.txt b/doc/src/minimize.txt index ecf1ad0fcf..1dc28acdef 100644 --- a/doc/src/minimize.txt +++ b/doc/src/minimize.txt @@ -103,7 +103,8 @@ the line search fails because the step distance backtracks to 0.0 the number of outer iterations or timesteps exceeds {maxiter} the number of total force evaluations exceeds {maxeval} :ul -NOTE: the "minimization style"_min_style.html {spin} replaces +NOTE: the "minimization style"_min_style.html {spin}, +{spin_oso_cg}, and {spin_oso_lbfgs} replace the force tolerance {ftol} by a torque tolerance. The minimization procedure stops if the 2-norm (length) of the global torque vector (defined as the cross product between the diff --git a/doc/src/neb_spin.txt b/doc/src/neb_spin.txt index 7dbd924cd2..46478b1219 100644 --- a/doc/src/neb_spin.txt +++ b/doc/src/neb_spin.txt @@ -172,7 +172,8 @@ command is issued. A NEB calculation proceeds in two stages, each of which is a minimization procedure, performed via damped dynamics. To enable this, you must first define a damped spin dynamics -"min_style"_min_style.html, using the {spin} style (see +"min_style"_min_style.html, using either the {spin}, +{spin_oso_cg}, or {spin_oso_lbfgs} style (see "min_spin"_min_spin.html for more information). The other styles cannot be used, since they relax the lattice degrees of freedom instead of the spins. @@ -358,6 +359,9 @@ This command can only be used if LAMMPS was built with the SPIN package. See the "Build package"_Build_package.html doc page for more info. +The line search procedures of the {spin_oso_cg} and {spin_oso_lbfgs} +minimization styles cannot be used in a GNEB calculation. + :line [Related commands:] diff --git a/doc/src/pair_spin_dipole.txt b/doc/src/pair_spin_dipole.txt index 0d6471e07f..735c71139a 100644 --- a/doc/src/pair_spin_dipole.txt +++ b/doc/src/pair_spin_dipole.txt @@ -25,9 +25,8 @@ pair_coeff * * 10.0 pair_coeff 2 3 8.0 :pre pair_style spin/dipole/long 9.0 -pair_coeff * * 1.0 1.0 -pair_coeff 2 3 1.0 1.0 2.5 4.0 scale 0.5 -pair_coeff 2 3 1.0 1.0 2.5 4.0 :pre +pair_coeff * * 10.0 +pair_coeff 2 3 6.0 :pre [Description:] diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spinmin_cg.bfo new file mode 100644 index 0000000000..cd6ec485ad --- /dev/null +++ b/examples/SPIN/spinmin/in.spinmin_cg.bfo @@ -0,0 +1,54 @@ +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 1.0 +create_box 1 box +create_atoms 1 box + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +# pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/oso_cg +min_modify discrete_factor 10.0 line_search 0 +minimize 1.0e-10 1.0e-10 10000 1000 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo new file mode 100644 index 0000000000..5db44522e1 --- /dev/null +++ b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo @@ -0,0 +1,54 @@ +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 1.0 +create_box 1 box +create_atoms 1 box + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +#pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/oso_lbfgs +min_modify discrete_factor 10.0 line_search 1 +minimize 1.0e-15 1.0e-10 10000 1000 diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 9849ba9946..f56c9f0d96 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -80,12 +80,12 @@ void MinSpin::setup_style() int MinSpin::modify_param(int narg, char **arg) { if (strcmp(arg[0],"alpha_damp") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + if (narg < 2) error->all(FLERR,"Illegal min_modify command"); alpha_damp = force->numeric(FLERR,arg[1]); return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + if (narg < 2) error->all(FLERR,"Illegal min_modify command"); discrete_factor = force->numeric(FLERR,arg[1]); return 2; } diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 843f1e48f1..e43c51e3af 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -133,12 +133,10 @@ void MinSpinOSO_CG::setup_style() int MinSpinOSO_CG::modify_param(int narg, char **arg) { if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + if (narg < 2) error->all(FLERR,"Illegal min_modify command"); use_line_search = force->numeric(FLERR,arg[1]); - if (nreplica > 1 && use_line_search) error->all(FLERR,"Illegal fix_modify command, cannot use NEB and line search together"); - return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { @@ -250,9 +248,9 @@ int MinSpinOSO_CG::iterate(int maxiter) neval++; } - //// energy tolerance criterion - //// only check after DELAYSTEP elapsed since velocties reset to 0 - //// sync across replicas if running multi-replica minimization + // energy tolerance criterion + // only check after DELAYSTEP elapsed since velocties reset to 0 + // sync across replicas if running multi-replica minimization if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { if (update->multireplica == 0) { @@ -680,4 +678,4 @@ double MinSpinOSO_CG::evaluate_dt() dtmax = MY_2PI/(discrete_factor*sqrt(fmaxsqall)); return dtmax; -} \ No newline at end of file +} diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index eba62f296f..0bd128367f 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -145,16 +145,14 @@ int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) { if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + if (narg < 2) error->all(FLERR,"Illegal min_modify command"); use_line_search = force->numeric(FLERR,arg[1]); - if (nreplica > 1 && use_line_search) - error->all(FLERR,"Illegal fix_modify command, cannot use NEB and line search together"); - + error->all(FLERR,"Illegal min_modify command, cannot use NEB and line search together"); return 2; } if (strcmp(arg[0],"discrete_factor") == 0) { - if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); + if (narg < 2) error->all(FLERR,"Illegal min_modify command"); double discrete_factor; discrete_factor = force->numeric(FLERR,arg[1]); maxepsrot = MY_2PI / (10 * discrete_factor); @@ -266,9 +264,9 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) neval++; } - //// energy tolerance criterion - //// only check after DELAYSTEP elapsed since velocties reset to 0 - //// sync across replicas if running multi-replica minimization + // energy tolerance criterion + // only check after DELAYSTEP elapsed since velocties reset to 0 + // sync across replicas if running multi-replica minimization if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { if (update->multireplica == 0) { @@ -802,4 +800,4 @@ double MinSpinOSO_LBFGS::maximum_rotation(double *p) else alpha = 1.0; return alpha; -} \ No newline at end of file +} From f1c3b9d0bf3fd4f27711e81eb11dbb70d79da5fb Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 23 Jul 2019 11:24:52 -0600 Subject: [PATCH 063/557] Commit2 JT 072319 - corrected some mistakes in doc files - modified oso examples to match new line options --- doc/src/min_modify.txt | 10 +++++----- doc/src/min_spin.txt | 5 +++-- doc/src/neb_spin.txt | 4 ++-- examples/SPIN/spinmin/in.spinmin_cg.bfo | 2 +- examples/SPIN/spinmin/in.spinmin_lbfgs.bfo | 2 +- src/SPIN/neb_spin.cpp | 2 +- 6 files changed, 13 insertions(+), 12 deletions(-) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index da7b593d16..c59e2b474b 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -13,7 +13,7 @@ min_modify command :h3 min_modify keyword values ... :pre one or more keyword/value pairs may be listed :ulb,l -keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} or {spin_cubic} or {spin_none} +keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} {dmax} value = max max = maximum distance for line search to move (distance units) {line} value = {backtrack} or {quadratic} or {forcezero} or {spin_cubic} or {spin_none} @@ -81,9 +81,9 @@ quantities. Default values are {alpha_damp} = 1.0 and {discrete_factor} = 10.0. The choice of a line search algorithm for the {spin_oso_cg} and -{spin_oso_lbfgs} can be specified via the {line} keyword. -The {spin_cubic} and {spin_none} only make sense when those two -when one of those two minimization styles is declared. +{spin_oso_lbfgs} styles can be specified via the {line} keyword. +The {spin_cubic} and {spin_none} only make sense when one of those +two minimization styles is declared. The {spin_cubic} keyword activates the line search procedure when the {spin_oso_cg} algorithm is used. @@ -93,7 +93,7 @@ the {spin_oso_lbfgs} algorithm is used. [Restrictions:] The line search procedure of styles {spin_oso_cg} and {spin_oso_lbfgs} cannot be used for magnetic -NEB calculations. See "neb/spin"_neb_spin.html for more +GNEB calculations. See "neb/spin"_neb_spin.html for more explanation. [Related commands:] diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 6883a4197c..2a85427c56 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -18,7 +18,7 @@ min_style spin_oso_lbfgs :pre [Examples:] min_style spin_oso_lbfgs -min_modify discrete_factor 10.0 line_search 0 :pre +min_modify discrete_factor 10.0 line spin_none :pre [Description:] @@ -62,7 +62,8 @@ Style {spin_oso_lbfgs} defines an orthogonal spin optimization (LBFGS) algorithm. By default, style {spin_oso_lbfgs} uses a line search procedure. The "min_modify"_min_modify.html command can be used to -deactivate the line search procedure. +deactivate the line search procedure, and to modify the +discretization factor {discrete_factor}. For more information about styles {spin_oso_cg} and {spin_oso_lbfgs}, see their implementation reported in "(Ivanov)"_#Ivanov1. diff --git a/doc/src/neb_spin.txt b/doc/src/neb_spin.txt index 46478b1219..27e835276e 100644 --- a/doc/src/neb_spin.txt +++ b/doc/src/neb_spin.txt @@ -60,8 +60,8 @@ processors per replica. See the "Howto replica"_Howto_replica.html doc page for further discussion. NOTE: As explained below, a GNEB calculation performs a damped dynamics -minimization across all the replicas. The "spin"_min_spin.html -style minimizer has to be defined in your input script. +minimization across all the replicas. One of the "spin"_min_spin.html +style minimizers has to be defined in your input script. When a GNEB calculation is performed, it is assumed that each replica is running the same system, though LAMMPS does not check for this. diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spinmin_cg.bfo index cd6ec485ad..901b04e5fd 100644 --- a/examples/SPIN/spinmin/in.spinmin_cg.bfo +++ b/examples/SPIN/spinmin/in.spinmin_cg.bfo @@ -50,5 +50,5 @@ compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] min_style spin/oso_cg -min_modify discrete_factor 10.0 line_search 0 +min_modify discrete_factor 10.0 line spin_cubic minimize 1.0e-10 1.0e-10 10000 1000 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo index 5db44522e1..4edd1a053e 100644 --- a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo +++ b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo @@ -50,5 +50,5 @@ compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] min_style spin/oso_lbfgs -min_modify discrete_factor 10.0 line_search 1 +min_modify discrete_factor 10.0 line spin_none minimize 1.0e-15 1.0e-10 10000 1000 diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 12d1d2a956..4fa1f4467b 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -650,7 +650,7 @@ int NEBSpin::initial_rotation(double *spi, double *sploc, double fraction) kcrossy = kz*spix - kx*spiz; kcrossz = kx*spiy - ky*spix; - kdots = kx*spix + ky*spiz + kz*spiz; + kdots = kx*spix + ky*spiy + kz*spiz; omega = acos(sidotsf); omega *= fraction; From 9c3760064c5f3c7566a7917e2e034b1907301f9a Mon Sep 17 00:00:00 2001 From: Jun-Chieh Wang Date: Tue, 23 Jul 2019 15:01:49 -0700 Subject: [PATCH 064/557] move it to the constructor --- src/MISC/fix_deposit.cpp | 13 ++++++++----- 1 file changed, 8 insertions(+), 5 deletions(-) diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index ca841b49bd..94449cbe5f 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -193,6 +193,14 @@ FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : next_reneighbor = update->ntimestep + 1; nfirst = next_reneighbor; ninserted = 0; + + // throw away the first few numbers to avoid the unexpected correlations + + double tmp_rand; + for (int ii=0; ii < 30; ii++) { + tmp_rand = random->uniform(); + } + } /* ---------------------------------------------------------------------- */ @@ -343,11 +351,6 @@ void FixDeposit::pre_exchange() // choose random position for new particle within region if (distflag == DIST_UNIFORM) { - // throw away the first few numbers to avoid the unexpected correlations - double tmp_rand; - for (int ii=0; ii < 30; ii++) { - tmp_rand = random->uniform(); - } do { coord[0] = xlo + random->uniform() * (xhi-xlo); coord[1] = ylo + random->uniform() * (yhi-ylo); From 15d791d0e3ff82b05fd5012daea2e6a9e41643a4 Mon Sep 17 00:00:00 2001 From: casievers Date: Tue, 23 Jul 2019 18:41:31 -0700 Subject: [PATCH 065/557] debugging gjf tally --- src/fix_langevin.cpp | 26 +++++++++++++------------- 1 file changed, 13 insertions(+), 13 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 7d5c382488..82366be4dd 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -673,9 +673,12 @@ void FixLangevin::post_force_untemplated if (Tp_TALLY) { if (Tp_GJF && update->ntimestep != update->beginstep){ - fdrag[0] = gamma1*gjffac*v[i][0]; - fdrag[1] = gamma1*gjffac*v[i][1]; - fdrag[2] = gamma1*gjffac*v[i][2]; + fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; + fran[0] *= gjffac; + fran[1] *= gjffac; + fran[2] *= gjffac; } else if (Tp_GJF && update->ntimestep == update->beginstep){ fdrag[0] = 0.0; @@ -902,14 +905,8 @@ void FixLangevin::end_of_step() v[i][2] = lv[i][2]; } } - if (tallyflag && hsflag){ - energy_onestep += gjffac*(flangevin[i][0] * lv[i][0] + - flangevin[i][1] * lv[i][1] + flangevin[i][2] * lv[i][2]); - } - else if (tallyflag){ - energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + - flangevin[i][2] * v[i][2]; - } + energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + + flangevin[i][2] * v[i][2]; } if (tallyflag) { energy += energy_onestep * update->dt; @@ -985,8 +982,11 @@ double FixLangevin::compute_scalar() } // convert midstep energy back to previous fullstep energy - - double energy_me = energy - 0.5*energy_onestep*update->dt; + double energy_me; + if (gjfflag) + energy_me = energy - energy_onestep*update->dt; + else + energy_me = energy - 0.5*energy_onestep*update->dt; double energy_all; MPI_Allreduce(&energy_me,&energy_all,1,MPI_DOUBLE,MPI_SUM,world); From fe7927af1180093ca062203656104910e0201f68 Mon Sep 17 00:00:00 2001 From: Jun-Chieh Wang Date: Wed, 24 Jul 2019 14:38:08 -0700 Subject: [PATCH 066/557] move it after the generator is constructed --- src/MISC/fix_deposit.cpp | 14 ++++++-------- 1 file changed, 6 insertions(+), 8 deletions(-) diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index 94449cbe5f..66493f810f 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -184,8 +184,14 @@ FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : if (idnext) find_maxid(); // random number generator, same for all procs + // warm-up the generator 30x to avoid correlations in first-particle + // positions if runs are repeated with consecutive seeds random = new RanPark(lmp,seed); + double tmp_rand; + for (int ii=0; ii < 30; ii++) { + tmp_rand = random->uniform(); + } // set up reneighboring @@ -193,14 +199,6 @@ FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : next_reneighbor = update->ntimestep + 1; nfirst = next_reneighbor; ninserted = 0; - - // throw away the first few numbers to avoid the unexpected correlations - - double tmp_rand; - for (int ii=0; ii < 30; ii++) { - tmp_rand = random->uniform(); - } - } /* ---------------------------------------------------------------------- */ From 25653e67f8a041890f1ff6ff933a0fe2f84250b6 Mon Sep 17 00:00:00 2001 From: casievers Date: Wed, 24 Jul 2019 16:05:25 -0700 Subject: [PATCH 067/557] Tally works and example readmes addes --- examples/gjf/README.md | 13 +++++++++++++ examples/python/gjf_python/README.md | 18 ++++++++++++++++++ src/fix_langevin.cpp | 5 ----- 3 files changed, 31 insertions(+), 5 deletions(-) create mode 100644 examples/gjf/README.md create mode 100644 examples/python/gjf_python/README.md diff --git a/examples/gjf/README.md b/examples/gjf/README.md new file mode 100644 index 0000000000..e285ab8510 --- /dev/null +++ b/examples/gjf/README.md @@ -0,0 +1,13 @@ +# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON + +## GJF-2GJ THERMOSTAT + +This directory contains the ingredients to run an NVT simulation using the GJF-2GJ thermostat. + +Example: +``` +NP=4 #number of processors +mpirun -np $NP lmp_mpi -in.argon -out.argon +``` + +## Required LAMMPS packages: MOLECULE package diff --git a/examples/python/gjf_python/README.md b/examples/python/gjf_python/README.md new file mode 100644 index 0000000000..707289f02d --- /dev/null +++ b/examples/python/gjf_python/README.md @@ -0,0 +1,18 @@ +# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON + +## GJF-2GJ THERMOSTAT + +This directory contains a python script to run NVT simulations using the GJF-2GJ thermostat. +The script will vary the timestep and write thermodynamic output to screen. +This script has True/False options to change how you would like to dump/write your output. + +Example: +``` +NP=4 #number of processors +mpirun -np $NP python gjf.py +``` + +## Required LAMMPS packages: MOLECULE package +## LAMMPS COMPILE MODE: SHLIB +## LAMMPS OPTIONAL INSTALL: make install-python +## Required Python packages: mpi4py diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 82366be4dd..4fcf7c6a1d 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -174,11 +174,6 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { - //int mem = 6*atom->nmax*sizeof(double); - //if (hsflag) mem += 3*atom->nmax*sizeof(double); -// - //comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); - //comm->maxexchange_fix += MAX(1000, mem); nvalues = 3; grow_arrays(atom->nmax); From f9ed12be4f0ff547661a6dffe420b67c76655379 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 24 Jul 2019 23:21:07 +0000 Subject: [PATCH 068/557] modify line for spin_cubic, spin_none. edit docs a bit. --- doc/src/min_modify.txt | 12 ++-- doc/src/min_spin.txt | 17 ++++-- doc/src/minimize.txt | 8 +-- doc/src/neb_spin.txt | 6 +- examples/SPIN/spinmin/in.spinmin_cg.bfo | 8 +-- examples/SPIN/spinmin/in.spinmin_lbfgs.bfo | 6 +- src/MAKE/Makefile.serial | 2 +- src/SPIN/min_spin_oso_cg.cpp | 64 +++++++++++----------- src/SPIN/min_spin_oso_cg.h | 4 +- src/SPIN/min_spin_oso_lbfgs.cpp | 48 +++++++--------- src/SPIN/min_spin_oso_lbfgs.h | 2 +- 11 files changed, 89 insertions(+), 88 deletions(-) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index c59e2b474b..9c4d7c8fcb 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -84,12 +84,12 @@ The choice of a line search algorithm for the {spin_oso_cg} and {spin_oso_lbfgs} styles can be specified via the {line} keyword. The {spin_cubic} and {spin_none} only make sense when one of those two minimization styles is declared. - -The {spin_cubic} keyword activates the line search procedure when -the {spin_oso_cg} algorithm is used. - -The {spin_none} keyword deactivates the line search procedure when -the {spin_oso_lbfgs} algorithm is used. +The {spin_cubic} performs the line search based on a cubic interpolation +of the energy along the search direction. The {spin_none} keyword +deactivates the line search procedure. +The {spin_none} is a default value for {line} keyword apart from the case when +single-replica calculations are performed with {spin_oso_lbfgs} that +uses {spin_cubic} line search. [Restrictions:] The line search procedure of styles {spin_oso_cg} and {spin_oso_lbfgs} cannot be used for magnetic diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 2a85427c56..77dc008b3e 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -18,7 +18,7 @@ min_style spin_oso_lbfgs :pre [Examples:] min_style spin_oso_lbfgs -min_modify discrete_factor 10.0 line spin_none :pre +min_modify line spin_none discrete_factor 10.0 :pre [Description:] @@ -55,12 +55,21 @@ Style {spin_oso_cg} defines an orthogonal spin optimization (OSO) combined to a conjugate gradient (CG) algorithm. The "min_modify"_min_modify.html command can be used to couple the {spin_oso_cg} to a line search procedure, and to modify the -discretization factor {discrete_factor}. +discretization factor {discrete_factor}. +By defualt, the style {spin_oso_cg} does not employ line search procedure and +and uses the adaptive time-step technique in the same way as style {spin}. Style {spin_oso_lbfgs} defines an orthogonal spin optimization (OSO) combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno -(LBFGS) algorithm. -By default, style {spin_oso_lbfgs} uses a line search procedure. +(L-BFGS) algorithm. +By default, style {spin_oso_lbfgs} uses a line search procedure +based on cubic interpolation for +a single-replica calculation, and it does not use line search procedure +for a multireplica calculation (such as in case of GNEB calculation). +If the line search procedure is not used then the discrete factor defines +the maximum root mean squared rotation angle of spins by equation {pi/(5*Kappa)}. +The default value for Kappa is 10. + The "min_modify"_min_modify.html command can be used to deactivate the line search procedure, and to modify the discretization factor {discrete_factor}. diff --git a/doc/src/minimize.txt b/doc/src/minimize.txt index 1dc28acdef..1de925d6c8 100644 --- a/doc/src/minimize.txt +++ b/doc/src/minimize.txt @@ -106,10 +106,10 @@ the number of total force evaluations exceeds {maxeval} :ul NOTE: the "minimization style"_min_style.html {spin}, {spin_oso_cg}, and {spin_oso_lbfgs} replace the force tolerance {ftol} by a torque tolerance. -The minimization procedure stops if the 2-norm (length) of the -global torque vector (defined as the cross product between the -spins and their precession vectors omega) is less than {ftol}, -or if any of the other criteria are met. +The minimization procedure stops if the 2-norm (length) of the torque vector on atom +(defined as the cross product between the +atomic spin and its precession vectors omega) is less than {ftol}, +or if any of the other criteria are met. Torque have the same units as the energy. NOTE: You can also use the "fix halt"_fix_halt.html command to specify a general criterion for exiting a minimization, that is a calculation diff --git a/doc/src/neb_spin.txt b/doc/src/neb_spin.txt index 27e835276e..2fdfda8c66 100644 --- a/doc/src/neb_spin.txt +++ b/doc/src/neb_spin.txt @@ -59,7 +59,7 @@ performance speed-up you would see with one or more physical processors per replica. See the "Howto replica"_Howto_replica.html doc page for further discussion. -NOTE: As explained below, a GNEB calculation performs a damped dynamics +NOTE: As explained below, a GNEB calculation performs a minimization across all the replicas. One of the "spin"_min_spin.html style minimizers has to be defined in your input script. @@ -170,8 +170,8 @@ command is issued. :line A NEB calculation proceeds in two stages, each of which is a -minimization procedure, performed via damped dynamics. To enable -this, you must first define a damped spin dynamics +minimization procedure. To enable +this, you must first define a "min_style"_min_style.html, using either the {spin}, {spin_oso_cg}, or {spin_oso_lbfgs} style (see "min_spin"_min_spin.html for more information). diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spinmin_cg.bfo index 901b04e5fd..776079edb8 100644 --- a/examples/SPIN/spinmin/in.spinmin_cg.bfo +++ b/examples/SPIN/spinmin/in.spinmin_cg.bfo @@ -42,13 +42,13 @@ variable magnorm equal c_out_mag[4] variable emag equal c_out_mag[5] variable tmag equal c_out_mag[6] -thermo 50 +thermo 100 thermo_style custom step time v_magnorm v_emag v_tmag temp etotal thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -min_style spin/oso_cg -min_modify discrete_factor 10.0 line spin_cubic -minimize 1.0e-10 1.0e-10 10000 1000 +min_style spin_oso_cg +# min_modify line spin_none discrete_factor 10.0 +minimize 1.0e-10 1.0e-7 1000 1000 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo index 4edd1a053e..ca600f1c2b 100644 --- a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo +++ b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo @@ -49,6 +49,6 @@ thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -min_style spin/oso_lbfgs -min_modify discrete_factor 10.0 line spin_none -minimize 1.0e-15 1.0e-10 10000 1000 +min_style spin_oso_lbfgs +min_modify line spin_cubic discrete_factor 10.0 +minimize 1.0e-15 1.0e-7 10000 1000 diff --git a/src/MAKE/Makefile.serial b/src/MAKE/Makefile.serial index 5954d97761..8628d2bb73 100644 --- a/src/MAKE/Makefile.serial +++ b/src/MAKE/Makefile.serial @@ -7,7 +7,7 @@ SHELL = /bin/sh # specify flags and libraries needed for your compiler CC = g++ -CCFLAGS = -g -O3 +CCFLAGS = -g -O3 -Wall SHFLAGS = -fPIC DEPFLAGS = -M diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index e43c51e3af..2bdc00d8ed 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -63,7 +63,7 @@ static const char cite_minstyle_spin_oso_cg[] = /* ---------------------------------------------------------------------- */ MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL) + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), sp_copy(NULL) { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); nlocal_max = 0; @@ -99,6 +99,13 @@ void MinSpinOSO_CG::init() Min::init(); + if (linestyle == 3 && nreplica == 1){ + use_line_search = 1; + } + else{ + use_line_search = 0; + } + dts = dt = update->dt; last_negative = update->ntimestep; @@ -132,13 +139,6 @@ void MinSpinOSO_CG::setup_style() int MinSpinOSO_CG::modify_param(int narg, char **arg) { - if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal min_modify command"); - use_line_search = force->numeric(FLERR,arg[1]); - if (nreplica > 1 && use_line_search) - error->all(FLERR,"Illegal fix_modify command, cannot use NEB and line search together"); - return 2; - } if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); discrete_factor = force->numeric(FLERR,arg[1]); @@ -181,7 +181,6 @@ int MinSpinOSO_CG::iterate(int maxiter) double der_e_cur_tmp = 0.0; if (nlocal_max < nlocal) { - nlocal_max = nlocal; local_iter = 0; nlocal_max = nlocal; memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); @@ -205,8 +204,9 @@ int MinSpinOSO_CG::iterate(int maxiter) if (use_line_search) { // here we need to do line search - if (local_iter == 0) + if (local_iter == 0){ calc_gradient(); + } calc_search_direction(); der_e_cur = 0.0; @@ -219,7 +219,7 @@ int MinSpinOSO_CG::iterate(int maxiter) } for (int i = 0; i < nlocal; i++) for (int j = 0; j < 3; j++) - sp_copy[i][j] = sp[i][j]; + sp_copy[i][j] = sp[i][j]; eprevious = ecurrent; der_e_pr = der_e_cur; @@ -228,24 +228,15 @@ int MinSpinOSO_CG::iterate(int maxiter) else{ // here we don't do line search - // but use cutoff rotation angle // if gneb calc., nreplica > 1 // then calculate gradients and advance spins // of intermediate replicas only - - if (nreplica > 1) { - if(ireplica != 0 && ireplica != nreplica-1) calc_gradient(); calc_search_direction(); advance_spins(); - } else{ - calc_gradient(); - calc_search_direction(); - advance_spins(); - } + neval++; eprevious = ecurrent; ecurrent = energy_force(0); - neval++; } // energy tolerance criterion @@ -336,10 +327,18 @@ void MinSpinOSO_CG::calc_search_direction() double g2_global = 0.0; double g2old_global = 0.0; + double factor = 1.0; + + // for multiple replica do not move end points + if (nreplica > 1) + if (ireplica == 0 || ireplica == nreplica - 1) + factor = 0.0; + + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = -g_cur[i]; - g_old[i] = g_cur[i]; + p_s[i] = -g_cur[i] * factor; + g_old[i] = g_cur[i] * factor; } } else { // conjugate direction for (int i = 0; i < 3 * nlocal; i++) { @@ -354,9 +353,9 @@ void MinSpinOSO_CG::calc_search_direction() MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); // Sum over all replicas. Good for GNEB. - if (update->multireplica == 1) { - g2 = g2_global; - g2old = g2old_global; + if (nreplica > 1) { + g2 = g2_global * factor; + g2old = g2old_global * factor; MPI_Allreduce(&g2,&g2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } @@ -364,8 +363,8 @@ void MinSpinOSO_CG::calc_search_direction() else beta = g2_global / g2old_global; // calculate conjugate direction for (int i = 0; i < 3 * nlocal; i++) { - p_s[i] = (beta * p_s[i] - g_cur[i]); - g_old[i] = g_cur[i]; + p_s[i] = (beta * p_s[i] - g_cur[i]) * factor; + g_old[i] = g_cur[i] * factor; } } @@ -380,8 +379,6 @@ void MinSpinOSO_CG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; @@ -477,7 +474,7 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) A = cos(theta); B = sin(theta); - D = 1 - A; + D = 1.0 - A; x = upp_tr[0]/theta; y = upp_tr[1]/theta; z = upp_tr[2]/theta; @@ -529,7 +526,7 @@ void MinSpinOSO_CG::make_step(double c, double *energy_and_der) double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; double **sp = atom->sp; - double der_e_cur_tmp = 0.0;; + double der_e_cur_tmp = 0.0; for (int i = 0; i < nlocal; i++) { @@ -629,7 +626,8 @@ int MinSpinOSO_CG::awc(double der_phi_0, double phi_0, double der_phi_j, double double delta = 0.1; double sigma = 0.9; - if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + if ((phi_j<=phi_0+eps*fabs(phi_0)) && + ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index e50d1a69db..41253f440f 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -13,7 +13,7 @@ #ifdef MINIMIZE_CLASS -MinimizeStyle(spin/oso_cg, MinSpinOSO_CG) +MinimizeStyle(spin_oso_cg, MinSpinOSO_CG) #else @@ -39,8 +39,8 @@ class MinSpinOSO_CG: public Min { int ireplica,nreplica; // for neb double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector - double *g_cur; // current gradient vector double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector double *p_s; // search direction vector double **sp_copy; // copy of the spins int local_iter; // for neb diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 0bd128367f..6aaeb7ca23 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -107,6 +107,13 @@ void MinSpinOSO_LBFGS::init() Min::init(); + if (linestyle != 4 && nreplica == 1){ + use_line_search = 1; + } + else{ + use_line_search = 0; + } + last_negative = update->ntimestep; // allocate tables @@ -143,14 +150,6 @@ void MinSpinOSO_LBFGS::setup_style() int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) { - - if (strcmp(arg[0],"line_search") == 0) { - if (narg < 2) error->all(FLERR,"Illegal min_modify command"); - use_line_search = force->numeric(FLERR,arg[1]); - if (nreplica > 1 && use_line_search) - error->all(FLERR,"Illegal min_modify command, cannot use NEB and line search together"); - return 2; - } if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal min_modify command"); double discrete_factor; @@ -221,8 +220,11 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) if (use_line_search) { // here we need to do line search - if (local_iter == 0) + if (local_iter == 0){ + eprevious = ecurrent; + ecurrent = energy_force(0); calc_gradient(); + } calc_search_direction(); der_e_cur = 0.0; @@ -248,19 +250,11 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // if gneb calc., nreplica > 1 // then calculate gradients and advance spins // of intermediate replicas only - - if (nreplica > 1) { - if(ireplica != 0 && ireplica != nreplica-1) - calc_gradient(); - calc_search_direction(); - advance_spins(); - } else{ - calc_gradient(); - calc_search_direction(); - advance_spins(); - } eprevious = ecurrent; ecurrent = energy_force(0); + calc_gradient(); + calc_search_direction(); + advance_spins(); neval++; } @@ -398,7 +392,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() } MPI_Allreduce(&dyds, &dyds_global, 1, MPI_DOUBLE, MPI_SUM, world); - if (update->multireplica == 1) { + if (nreplica > 1) { dyds_global *= factor; dyds = dyds_global; MPI_Allreduce(&dyds, &dyds_global, 1,MPI_DOUBLE,MPI_SUM,universe->uworld); @@ -437,7 +431,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() sq += ds[c_ind][i] * q[i]; } MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { + if (nreplica > 1) { sq_global *= factor; sq = sq_global; MPI_Allreduce(&sq,&sq_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); @@ -460,7 +454,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() yy += dy[m_index][i] * dy[m_index][i]; } MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { + if (nreplica > 1) { yy_global *= factor; yy = yy_global; MPI_Allreduce(&yy,&yy_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); @@ -493,7 +487,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() } MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { + if (nreplica > 1) { yr_global *= factor; yr = yr_global; MPI_Allreduce(&yr,&yr_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); @@ -668,7 +662,7 @@ void MinSpinOSO_LBFGS::make_step(double c, double *energy_and_der) double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; double **sp = atom->sp; - double der_e_cur_tmp = 0.0;; + double der_e_cur_tmp = 0.0; for (int i = 0; i < nlocal; i++) { @@ -784,12 +778,12 @@ double MinSpinOSO_LBFGS::maximum_rotation(double *p) for (int i = 0; i < 3 * nlocal; i++) norm2 += p[i] * p[i]; MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,world); - if (update->multireplica == 1) { + if (nreplica > 1) { norm2 = norm2_global; MPI_Allreduce(&norm2,&norm2_global,1,MPI_DOUBLE,MPI_SUM,universe->uworld); } MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,world); - if (update->multireplica == 1) { + if (nreplica > 1) { nlocal = ntotal; MPI_Allreduce(&nlocal,&ntotal,1,MPI_INT,MPI_SUM,universe->uworld); } diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index d74898aa8c..3071bacc35 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -13,7 +13,7 @@ #ifdef MINIMIZE_CLASS -MinimizeStyle(spin/oso_lbfgs, MinSpinOSO_LBFGS) +MinimizeStyle(spin_oso_lbfgs, MinSpinOSO_LBFGS) #else From 4a80edd75f5fb659fa1a9574642f16262fcd2dec Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 13:36:57 -0700 Subject: [PATCH 069/557] updated fix_langevin and made example --- examples/gjf/argon.lmp | 886 ++++++++++++++++++++++++++++++++++ examples/gjf/ff-argon.lmp | 20 + examples/gjf/in.argon | 162 +++++++ examples/gjf/out.argon | 249 ++++++++++ examples/gjf/trajectory.0.dcd | Bin 0 -> 439092 bytes src/fix_langevin.cpp | 272 +++++++++-- src/fix_langevin.h | 7 +- 7 files changed, 1550 insertions(+), 46 deletions(-) create mode 100644 examples/gjf/argon.lmp create mode 100644 examples/gjf/ff-argon.lmp create mode 100644 examples/gjf/in.argon create mode 100644 examples/gjf/out.argon create mode 100644 examples/gjf/trajectory.0.dcd diff --git a/examples/gjf/argon.lmp b/examples/gjf/argon.lmp new file mode 100644 index 0000000000..00214b4c54 --- /dev/null +++ b/examples/gjf/argon.lmp @@ -0,0 +1,886 @@ +LAMMPS description + + 864 atoms + 0 bonds + 0 angles + 0 dihedrals + 0 impropers + + 1 atom types + 0 bond types + 0 angle types + 0 dihedral types + 0 improper types + + + 0.0000000 32.146000 xlo xhi + 0.0000000 32.146000 ylo yhi + 0.0000000 32.146000 zlo zhi + + Atoms + + 1 1 1 0.0000000 0.0000000 2.6790000 2.6790000 + 2 2 1 0.0000000 0.0000000 2.6790000 8.0360000 + 3 3 1 0.0000000 0.0000000 2.6790000 13.3940000 + 4 4 1 0.0000000 0.0000000 2.6790000 18.7520000 + 5 5 1 0.0000000 0.0000000 2.6790000 24.1090000 + 6 6 1 0.0000000 0.0000000 2.6790000 29.4670000 + 7 7 1 0.0000000 0.0000000 8.0360000 2.6790000 + 8 8 1 0.0000000 0.0000000 8.0360000 8.0360000 + 9 9 1 0.0000000 0.0000000 8.0360000 13.3940000 + 10 10 1 0.0000000 0.0000000 8.0360000 18.7520000 + 11 11 1 0.0000000 0.0000000 8.0360000 24.1090000 + 12 12 1 0.0000000 0.0000000 8.0360000 29.4670000 + 13 13 1 0.0000000 0.0000000 13.3940000 2.6790000 + 14 14 1 0.0000000 0.0000000 13.3940000 8.0360000 + 15 15 1 0.0000000 0.0000000 13.3940000 13.3940000 + 16 16 1 0.0000000 0.0000000 13.3940000 18.7520000 + 17 17 1 0.0000000 0.0000000 13.3940000 24.1090000 + 18 18 1 0.0000000 0.0000000 13.3940000 29.4670000 + 19 19 1 0.0000000 0.0000000 18.7520000 2.6790000 + 20 20 1 0.0000000 0.0000000 18.7520000 8.0360000 + 21 21 1 0.0000000 0.0000000 18.7520000 13.3940000 + 22 22 1 0.0000000 0.0000000 18.7520000 18.7520000 + 23 23 1 0.0000000 0.0000000 18.7520000 24.1090000 + 24 24 1 0.0000000 0.0000000 18.7520000 29.4670000 + 25 25 1 0.0000000 0.0000000 24.1090000 2.6790000 + 26 26 1 0.0000000 0.0000000 24.1090000 8.0360000 + 27 27 1 0.0000000 0.0000000 24.1090000 13.3940000 + 28 28 1 0.0000000 0.0000000 24.1090000 18.7520000 + 29 29 1 0.0000000 0.0000000 24.1090000 24.1090000 + 30 30 1 0.0000000 0.0000000 24.1090000 29.4670000 + 31 31 1 0.0000000 0.0000000 29.4670000 2.6790000 + 32 32 1 0.0000000 0.0000000 29.4670000 8.0360000 + 33 33 1 0.0000000 0.0000000 29.4670000 13.3940000 + 34 34 1 0.0000000 0.0000000 29.4670000 18.7520000 + 35 35 1 0.0000000 0.0000000 29.4670000 24.1090000 + 36 36 1 0.0000000 0.0000000 29.4670000 29.4670000 + 37 37 1 0.0000000 5.3580000 2.6790000 2.6790000 + 38 38 1 0.0000000 5.3580000 2.6790000 8.0360000 + 39 39 1 0.0000000 5.3580000 2.6790000 13.3940000 + 40 40 1 0.0000000 5.3580000 2.6790000 18.7520000 + 41 41 1 0.0000000 5.3580000 2.6790000 24.1090000 + 42 42 1 0.0000000 5.3580000 2.6790000 29.4670000 + 43 43 1 0.0000000 5.3580000 8.0360000 2.6790000 + 44 44 1 0.0000000 5.3580000 8.0360000 8.0360000 + 45 45 1 0.0000000 5.3580000 8.0360000 13.3940000 + 46 46 1 0.0000000 5.3580000 8.0360000 18.7520000 + 47 47 1 0.0000000 5.3580000 8.0360000 24.1090000 + 48 48 1 0.0000000 5.3580000 8.0360000 29.4670000 + 49 49 1 0.0000000 5.3580000 13.3940000 2.6790000 + 50 50 1 0.0000000 5.3580000 13.3940000 8.0360000 + 51 51 1 0.0000000 5.3580000 13.3940000 13.3940000 + 52 52 1 0.0000000 5.3580000 13.3940000 18.7520000 + 53 53 1 0.0000000 5.3580000 13.3940000 24.1090000 + 54 54 1 0.0000000 5.3580000 13.3940000 29.4670000 + 55 55 1 0.0000000 5.3580000 18.7520000 2.6790000 + 56 56 1 0.0000000 5.3580000 18.7520000 8.0360000 + 57 57 1 0.0000000 5.3580000 18.7520000 13.3940000 + 58 58 1 0.0000000 5.3580000 18.7520000 18.7520000 + 59 59 1 0.0000000 5.3580000 18.7520000 24.1090000 + 60 60 1 0.0000000 5.3580000 18.7520000 29.4670000 + 61 61 1 0.0000000 5.3580000 24.1090000 2.6790000 + 62 62 1 0.0000000 5.3580000 24.1090000 8.0360000 + 63 63 1 0.0000000 5.3580000 24.1090000 13.3940000 + 64 64 1 0.0000000 5.3580000 24.1090000 18.7520000 + 65 65 1 0.0000000 5.3580000 24.1090000 24.1090000 + 66 66 1 0.0000000 5.3580000 24.1090000 29.4670000 + 67 67 1 0.0000000 5.3580000 29.4670000 2.6790000 + 68 68 1 0.0000000 5.3580000 29.4670000 8.0360000 + 69 69 1 0.0000000 5.3580000 29.4670000 13.3940000 + 70 70 1 0.0000000 5.3580000 29.4670000 18.7520000 + 71 71 1 0.0000000 5.3580000 29.4670000 24.1090000 + 72 72 1 0.0000000 5.3580000 29.4670000 29.4670000 + 73 73 1 0.0000000 10.7150000 2.6790000 2.6790000 + 74 74 1 0.0000000 10.7150000 2.6790000 8.0360000 + 75 75 1 0.0000000 10.7150000 2.6790000 13.3940000 + 76 76 1 0.0000000 10.7150000 2.6790000 18.7520000 + 77 77 1 0.0000000 10.7150000 2.6790000 24.1090000 + 78 78 1 0.0000000 10.7150000 2.6790000 29.4670000 + 79 79 1 0.0000000 10.7150000 8.0360000 2.6790000 + 80 80 1 0.0000000 10.7150000 8.0360000 8.0360000 + 81 81 1 0.0000000 10.7150000 8.0360000 13.3940000 + 82 82 1 0.0000000 10.7150000 8.0360000 18.7520000 + 83 83 1 0.0000000 10.7150000 8.0360000 24.1090000 + 84 84 1 0.0000000 10.7150000 8.0360000 29.4670000 + 85 85 1 0.0000000 10.7150000 13.3940000 2.6790000 + 86 86 1 0.0000000 10.7150000 13.3940000 8.0360000 + 87 87 1 0.0000000 10.7150000 13.3940000 13.3940000 + 88 88 1 0.0000000 10.7150000 13.3940000 18.7520000 + 89 89 1 0.0000000 10.7150000 13.3940000 24.1090000 + 90 90 1 0.0000000 10.7150000 13.3940000 29.4670000 + 91 91 1 0.0000000 10.7150000 18.7520000 2.6790000 + 92 92 1 0.0000000 10.7150000 18.7520000 8.0360000 + 93 93 1 0.0000000 10.7150000 18.7520000 13.3940000 + 94 94 1 0.0000000 10.7150000 18.7520000 18.7520000 + 95 95 1 0.0000000 10.7150000 18.7520000 24.1090000 + 96 96 1 0.0000000 10.7150000 18.7520000 29.4670000 + 97 97 1 0.0000000 10.7150000 24.1090000 2.6790000 + 98 98 1 0.0000000 10.7150000 24.1090000 8.0360000 + 99 99 1 0.0000000 10.7150000 24.1090000 13.3940000 + 100 100 1 0.0000000 10.7150000 24.1090000 18.7520000 + 101 101 1 0.0000000 10.7150000 24.1090000 24.1090000 + 102 102 1 0.0000000 10.7150000 24.1090000 29.4670000 + 103 103 1 0.0000000 10.7150000 29.4670000 2.6790000 + 104 104 1 0.0000000 10.7150000 29.4670000 8.0360000 + 105 105 1 0.0000000 10.7150000 29.4670000 13.3940000 + 106 106 1 0.0000000 10.7150000 29.4670000 18.7520000 + 107 107 1 0.0000000 10.7150000 29.4670000 24.1090000 + 108 108 1 0.0000000 10.7150000 29.4670000 29.4670000 + 109 109 1 0.0000000 16.0730000 2.6790000 2.6790000 + 110 110 1 0.0000000 16.0730000 2.6790000 8.0360000 + 111 111 1 0.0000000 16.0730000 2.6790000 13.3940000 + 112 112 1 0.0000000 16.0730000 2.6790000 18.7520000 + 113 113 1 0.0000000 16.0730000 2.6790000 24.1090000 + 114 114 1 0.0000000 16.0730000 2.6790000 29.4670000 + 115 115 1 0.0000000 16.0730000 8.0360000 2.6790000 + 116 116 1 0.0000000 16.0730000 8.0360000 8.0360000 + 117 117 1 0.0000000 16.0730000 8.0360000 13.3940000 + 118 118 1 0.0000000 16.0730000 8.0360000 18.7520000 + 119 119 1 0.0000000 16.0730000 8.0360000 24.1090000 + 120 120 1 0.0000000 16.0730000 8.0360000 29.4670000 + 121 121 1 0.0000000 16.0730000 13.3940000 2.6790000 + 122 122 1 0.0000000 16.0730000 13.3940000 8.0360000 + 123 123 1 0.0000000 16.0730000 13.3940000 13.3940000 + 124 124 1 0.0000000 16.0730000 13.3940000 18.7520000 + 125 125 1 0.0000000 16.0730000 13.3940000 24.1090000 + 126 126 1 0.0000000 16.0730000 13.3940000 29.4670000 + 127 127 1 0.0000000 16.0730000 18.7520000 2.6790000 + 128 128 1 0.0000000 16.0730000 18.7520000 8.0360000 + 129 129 1 0.0000000 16.0730000 18.7520000 13.3940000 + 130 130 1 0.0000000 16.0730000 18.7520000 18.7520000 + 131 131 1 0.0000000 16.0730000 18.7520000 24.1090000 + 132 132 1 0.0000000 16.0730000 18.7520000 29.4670000 + 133 133 1 0.0000000 16.0730000 24.1090000 2.6790000 + 134 134 1 0.0000000 16.0730000 24.1090000 8.0360000 + 135 135 1 0.0000000 16.0730000 24.1090000 13.3940000 + 136 136 1 0.0000000 16.0730000 24.1090000 18.7520000 + 137 137 1 0.0000000 16.0730000 24.1090000 24.1090000 + 138 138 1 0.0000000 16.0730000 24.1090000 29.4670000 + 139 139 1 0.0000000 16.0730000 29.4670000 2.6790000 + 140 140 1 0.0000000 16.0730000 29.4670000 8.0360000 + 141 141 1 0.0000000 16.0730000 29.4670000 13.3940000 + 142 142 1 0.0000000 16.0730000 29.4670000 18.7520000 + 143 143 1 0.0000000 16.0730000 29.4670000 24.1090000 + 144 144 1 0.0000000 16.0730000 29.4670000 29.4670000 + 145 145 1 0.0000000 21.4310000 2.6790000 2.6790000 + 146 146 1 0.0000000 21.4310000 2.6790000 8.0360000 + 147 147 1 0.0000000 21.4310000 2.6790000 13.3940000 + 148 148 1 0.0000000 21.4310000 2.6790000 18.7520000 + 149 149 1 0.0000000 21.4310000 2.6790000 24.1090000 + 150 150 1 0.0000000 21.4310000 2.6790000 29.4670000 + 151 151 1 0.0000000 21.4310000 8.0360000 2.6790000 + 152 152 1 0.0000000 21.4310000 8.0360000 8.0360000 + 153 153 1 0.0000000 21.4310000 8.0360000 13.3940000 + 154 154 1 0.0000000 21.4310000 8.0360000 18.7520000 + 155 155 1 0.0000000 21.4310000 8.0360000 24.1090000 + 156 156 1 0.0000000 21.4310000 8.0360000 29.4670000 + 157 157 1 0.0000000 21.4310000 13.3940000 2.6790000 + 158 158 1 0.0000000 21.4310000 13.3940000 8.0360000 + 159 159 1 0.0000000 21.4310000 13.3940000 13.3940000 + 160 160 1 0.0000000 21.4310000 13.3940000 18.7520000 + 161 161 1 0.0000000 21.4310000 13.3940000 24.1090000 + 162 162 1 0.0000000 21.4310000 13.3940000 29.4670000 + 163 163 1 0.0000000 21.4310000 18.7520000 2.6790000 + 164 164 1 0.0000000 21.4310000 18.7520000 8.0360000 + 165 165 1 0.0000000 21.4310000 18.7520000 13.3940000 + 166 166 1 0.0000000 21.4310000 18.7520000 18.7520000 + 167 167 1 0.0000000 21.4310000 18.7520000 24.1090000 + 168 168 1 0.0000000 21.4310000 18.7520000 29.4670000 + 169 169 1 0.0000000 21.4310000 24.1090000 2.6790000 + 170 170 1 0.0000000 21.4310000 24.1090000 8.0360000 + 171 171 1 0.0000000 21.4310000 24.1090000 13.3940000 + 172 172 1 0.0000000 21.4310000 24.1090000 18.7520000 + 173 173 1 0.0000000 21.4310000 24.1090000 24.1090000 + 174 174 1 0.0000000 21.4310000 24.1090000 29.4670000 + 175 175 1 0.0000000 21.4310000 29.4670000 2.6790000 + 176 176 1 0.0000000 21.4310000 29.4670000 8.0360000 + 177 177 1 0.0000000 21.4310000 29.4670000 13.3940000 + 178 178 1 0.0000000 21.4310000 29.4670000 18.7520000 + 179 179 1 0.0000000 21.4310000 29.4670000 24.1090000 + 180 180 1 0.0000000 21.4310000 29.4670000 29.4670000 + 181 181 1 0.0000000 26.7880000 2.6790000 2.6790000 + 182 182 1 0.0000000 26.7880000 2.6790000 8.0360000 + 183 183 1 0.0000000 26.7880000 2.6790000 13.3940000 + 184 184 1 0.0000000 26.7880000 2.6790000 18.7520000 + 185 185 1 0.0000000 26.7880000 2.6790000 24.1090000 + 186 186 1 0.0000000 26.7880000 2.6790000 29.4670000 + 187 187 1 0.0000000 26.7880000 8.0360000 2.6790000 + 188 188 1 0.0000000 26.7880000 8.0360000 8.0360000 + 189 189 1 0.0000000 26.7880000 8.0360000 13.3940000 + 190 190 1 0.0000000 26.7880000 8.0360000 18.7520000 + 191 191 1 0.0000000 26.7880000 8.0360000 24.1090000 + 192 192 1 0.0000000 26.7880000 8.0360000 29.4670000 + 193 193 1 0.0000000 26.7880000 13.3940000 2.6790000 + 194 194 1 0.0000000 26.7880000 13.3940000 8.0360000 + 195 195 1 0.0000000 26.7880000 13.3940000 13.3940000 + 196 196 1 0.0000000 26.7880000 13.3940000 18.7520000 + 197 197 1 0.0000000 26.7880000 13.3940000 24.1090000 + 198 198 1 0.0000000 26.7880000 13.3940000 29.4670000 + 199 199 1 0.0000000 26.7880000 18.7520000 2.6790000 + 200 200 1 0.0000000 26.7880000 18.7520000 8.0360000 + 201 201 1 0.0000000 26.7880000 18.7520000 13.3940000 + 202 202 1 0.0000000 26.7880000 18.7520000 18.7520000 + 203 203 1 0.0000000 26.7880000 18.7520000 24.1090000 + 204 204 1 0.0000000 26.7880000 18.7520000 29.4670000 + 205 205 1 0.0000000 26.7880000 24.1090000 2.6790000 + 206 206 1 0.0000000 26.7880000 24.1090000 8.0360000 + 207 207 1 0.0000000 26.7880000 24.1090000 13.3940000 + 208 208 1 0.0000000 26.7880000 24.1090000 18.7520000 + 209 209 1 0.0000000 26.7880000 24.1090000 24.1090000 + 210 210 1 0.0000000 26.7880000 24.1090000 29.4670000 + 211 211 1 0.0000000 26.7880000 29.4670000 2.6790000 + 212 212 1 0.0000000 26.7880000 29.4670000 8.0360000 + 213 213 1 0.0000000 26.7880000 29.4670000 13.3940000 + 214 214 1 0.0000000 26.7880000 29.4670000 18.7520000 + 215 215 1 0.0000000 26.7880000 29.4670000 24.1090000 + 216 216 1 0.0000000 26.7880000 29.4670000 29.4670000 + 217 217 1 0.0000000 2.6790000 5.3580000 2.6790000 + 218 218 1 0.0000000 2.6790000 5.3580000 8.0360000 + 219 219 1 0.0000000 2.6790000 5.3580000 13.3940000 + 220 220 1 0.0000000 2.6790000 5.3580000 18.7520000 + 221 221 1 0.0000000 2.6790000 5.3580000 24.1090000 + 222 222 1 0.0000000 2.6790000 5.3580000 29.4670000 + 223 223 1 0.0000000 2.6790000 10.7150000 2.6790000 + 224 224 1 0.0000000 2.6790000 10.7150000 8.0360000 + 225 225 1 0.0000000 2.6790000 10.7150000 13.3940000 + 226 226 1 0.0000000 2.6790000 10.7150000 18.7520000 + 227 227 1 0.0000000 2.6790000 10.7150000 24.1090000 + 228 228 1 0.0000000 2.6790000 10.7150000 29.4670000 + 229 229 1 0.0000000 2.6790000 16.0730000 2.6790000 + 230 230 1 0.0000000 2.6790000 16.0730000 8.0360000 + 231 231 1 0.0000000 2.6790000 16.0730000 13.3940000 + 232 232 1 0.0000000 2.6790000 16.0730000 18.7520000 + 233 233 1 0.0000000 2.6790000 16.0730000 24.1090000 + 234 234 1 0.0000000 2.6790000 16.0730000 29.4670000 + 235 235 1 0.0000000 2.6790000 21.4310000 2.6790000 + 236 236 1 0.0000000 2.6790000 21.4310000 8.0360000 + 237 237 1 0.0000000 2.6790000 21.4310000 13.3940000 + 238 238 1 0.0000000 2.6790000 21.4310000 18.7520000 + 239 239 1 0.0000000 2.6790000 21.4310000 24.1090000 + 240 240 1 0.0000000 2.6790000 21.4310000 29.4670000 + 241 241 1 0.0000000 2.6790000 26.7880000 2.6790000 + 242 242 1 0.0000000 2.6790000 26.7880000 8.0360000 + 243 243 1 0.0000000 2.6790000 26.7880000 13.3940000 + 244 244 1 0.0000000 2.6790000 26.7880000 18.7520000 + 245 245 1 0.0000000 2.6790000 26.7880000 24.1090000 + 246 246 1 0.0000000 2.6790000 26.7880000 29.4670000 + 247 247 1 0.0000000 2.6790000 32.1460000 2.6790000 + 248 248 1 0.0000000 2.6790000 32.1460000 8.0360000 + 249 249 1 0.0000000 2.6790000 32.1460000 13.3940000 + 250 250 1 0.0000000 2.6790000 32.1460000 18.7520000 + 251 251 1 0.0000000 2.6790000 32.1460000 24.1090000 + 252 252 1 0.0000000 2.6790000 32.1460000 29.4670000 + 253 253 1 0.0000000 8.0360000 5.3580000 2.6790000 + 254 254 1 0.0000000 8.0360000 5.3580000 8.0360000 + 255 255 1 0.0000000 8.0360000 5.3580000 13.3940000 + 256 256 1 0.0000000 8.0360000 5.3580000 18.7520000 + 257 257 1 0.0000000 8.0360000 5.3580000 24.1090000 + 258 258 1 0.0000000 8.0360000 5.3580000 29.4670000 + 259 259 1 0.0000000 8.0360000 10.7150000 2.6790000 + 260 260 1 0.0000000 8.0360000 10.7150000 8.0360000 + 261 261 1 0.0000000 8.0360000 10.7150000 13.3940000 + 262 262 1 0.0000000 8.0360000 10.7150000 18.7520000 + 263 263 1 0.0000000 8.0360000 10.7150000 24.1090000 + 264 264 1 0.0000000 8.0360000 10.7150000 29.4670000 + 265 265 1 0.0000000 8.0360000 16.0730000 2.6790000 + 266 266 1 0.0000000 8.0360000 16.0730000 8.0360000 + 267 267 1 0.0000000 8.0360000 16.0730000 13.3940000 + 268 268 1 0.0000000 8.0360000 16.0730000 18.7520000 + 269 269 1 0.0000000 8.0360000 16.0730000 24.1090000 + 270 270 1 0.0000000 8.0360000 16.0730000 29.4670000 + 271 271 1 0.0000000 8.0360000 21.4310000 2.6790000 + 272 272 1 0.0000000 8.0360000 21.4310000 8.0360000 + 273 273 1 0.0000000 8.0360000 21.4310000 13.3940000 + 274 274 1 0.0000000 8.0360000 21.4310000 18.7520000 + 275 275 1 0.0000000 8.0360000 21.4310000 24.1090000 + 276 276 1 0.0000000 8.0360000 21.4310000 29.4670000 + 277 277 1 0.0000000 8.0360000 26.7880000 2.6790000 + 278 278 1 0.0000000 8.0360000 26.7880000 8.0360000 + 279 279 1 0.0000000 8.0360000 26.7880000 13.3940000 + 280 280 1 0.0000000 8.0360000 26.7880000 18.7520000 + 281 281 1 0.0000000 8.0360000 26.7880000 24.1090000 + 282 282 1 0.0000000 8.0360000 26.7880000 29.4670000 + 283 283 1 0.0000000 8.0360000 32.1460000 2.6790000 + 284 284 1 0.0000000 8.0360000 32.1460000 8.0360000 + 285 285 1 0.0000000 8.0360000 32.1460000 13.3940000 + 286 286 1 0.0000000 8.0360000 32.1460000 18.7520000 + 287 287 1 0.0000000 8.0360000 32.1460000 24.1090000 + 288 288 1 0.0000000 8.0360000 32.1460000 29.4670000 + 289 289 1 0.0000000 13.3940000 5.3580000 2.6790000 + 290 290 1 0.0000000 13.3940000 5.3580000 8.0360000 + 291 291 1 0.0000000 13.3940000 5.3580000 13.3940000 + 292 292 1 0.0000000 13.3940000 5.3580000 18.7520000 + 293 293 1 0.0000000 13.3940000 5.3580000 24.1090000 + 294 294 1 0.0000000 13.3940000 5.3580000 29.4670000 + 295 295 1 0.0000000 13.3940000 10.7150000 2.6790000 + 296 296 1 0.0000000 13.3940000 10.7150000 8.0360000 + 297 297 1 0.0000000 13.3940000 10.7150000 13.3940000 + 298 298 1 0.0000000 13.3940000 10.7150000 18.7520000 + 299 299 1 0.0000000 13.3940000 10.7150000 24.1090000 + 300 300 1 0.0000000 13.3940000 10.7150000 29.4670000 + 301 301 1 0.0000000 13.3940000 16.0730000 2.6790000 + 302 302 1 0.0000000 13.3940000 16.0730000 8.0360000 + 303 303 1 0.0000000 13.3940000 16.0730000 13.3940000 + 304 304 1 0.0000000 13.3940000 16.0730000 18.7520000 + 305 305 1 0.0000000 13.3940000 16.0730000 24.1090000 + 306 306 1 0.0000000 13.3940000 16.0730000 29.4670000 + 307 307 1 0.0000000 13.3940000 21.4310000 2.6790000 + 308 308 1 0.0000000 13.3940000 21.4310000 8.0360000 + 309 309 1 0.0000000 13.3940000 21.4310000 13.3940000 + 310 310 1 0.0000000 13.3940000 21.4310000 18.7520000 + 311 311 1 0.0000000 13.3940000 21.4310000 24.1090000 + 312 312 1 0.0000000 13.3940000 21.4310000 29.4670000 + 313 313 1 0.0000000 13.3940000 26.7880000 2.6790000 + 314 314 1 0.0000000 13.3940000 26.7880000 8.0360000 + 315 315 1 0.0000000 13.3940000 26.7880000 13.3940000 + 316 316 1 0.0000000 13.3940000 26.7880000 18.7520000 + 317 317 1 0.0000000 13.3940000 26.7880000 24.1090000 + 318 318 1 0.0000000 13.3940000 26.7880000 29.4670000 + 319 319 1 0.0000000 13.3940000 32.1460000 2.6790000 + 320 320 1 0.0000000 13.3940000 32.1460000 8.0360000 + 321 321 1 0.0000000 13.3940000 32.1460000 13.3940000 + 322 322 1 0.0000000 13.3940000 32.1460000 18.7520000 + 323 323 1 0.0000000 13.3940000 32.1460000 24.1090000 + 324 324 1 0.0000000 13.3940000 32.1460000 29.4670000 + 325 325 1 0.0000000 18.7520000 5.3580000 2.6790000 + 326 326 1 0.0000000 18.7520000 5.3580000 8.0360000 + 327 327 1 0.0000000 18.7520000 5.3580000 13.3940000 + 328 328 1 0.0000000 18.7520000 5.3580000 18.7520000 + 329 329 1 0.0000000 18.7520000 5.3580000 24.1090000 + 330 330 1 0.0000000 18.7520000 5.3580000 29.4670000 + 331 331 1 0.0000000 18.7520000 10.7150000 2.6790000 + 332 332 1 0.0000000 18.7520000 10.7150000 8.0360000 + 333 333 1 0.0000000 18.7520000 10.7150000 13.3940000 + 334 334 1 0.0000000 18.7520000 10.7150000 18.7520000 + 335 335 1 0.0000000 18.7520000 10.7150000 24.1090000 + 336 336 1 0.0000000 18.7520000 10.7150000 29.4670000 + 337 337 1 0.0000000 18.7520000 16.0730000 2.6790000 + 338 338 1 0.0000000 18.7520000 16.0730000 8.0360000 + 339 339 1 0.0000000 18.7520000 16.0730000 13.3940000 + 340 340 1 0.0000000 18.7520000 16.0730000 18.7520000 + 341 341 1 0.0000000 18.7520000 16.0730000 24.1090000 + 342 342 1 0.0000000 18.7520000 16.0730000 29.4670000 + 343 343 1 0.0000000 18.7520000 21.4310000 2.6790000 + 344 344 1 0.0000000 18.7520000 21.4310000 8.0360000 + 345 345 1 0.0000000 18.7520000 21.4310000 13.3940000 + 346 346 1 0.0000000 18.7520000 21.4310000 18.7520000 + 347 347 1 0.0000000 18.7520000 21.4310000 24.1090000 + 348 348 1 0.0000000 18.7520000 21.4310000 29.4670000 + 349 349 1 0.0000000 18.7520000 26.7880000 2.6790000 + 350 350 1 0.0000000 18.7520000 26.7880000 8.0360000 + 351 351 1 0.0000000 18.7520000 26.7880000 13.3940000 + 352 352 1 0.0000000 18.7520000 26.7880000 18.7520000 + 353 353 1 0.0000000 18.7520000 26.7880000 24.1090000 + 354 354 1 0.0000000 18.7520000 26.7880000 29.4670000 + 355 355 1 0.0000000 18.7520000 32.1460000 2.6790000 + 356 356 1 0.0000000 18.7520000 32.1460000 8.0360000 + 357 357 1 0.0000000 18.7520000 32.1460000 13.3940000 + 358 358 1 0.0000000 18.7520000 32.1460000 18.7520000 + 359 359 1 0.0000000 18.7520000 32.1460000 24.1090000 + 360 360 1 0.0000000 18.7520000 32.1460000 29.4670000 + 361 361 1 0.0000000 24.1090000 5.3580000 2.6790000 + 362 362 1 0.0000000 24.1090000 5.3580000 8.0360000 + 363 363 1 0.0000000 24.1090000 5.3580000 13.3940000 + 364 364 1 0.0000000 24.1090000 5.3580000 18.7520000 + 365 365 1 0.0000000 24.1090000 5.3580000 24.1090000 + 366 366 1 0.0000000 24.1090000 5.3580000 29.4670000 + 367 367 1 0.0000000 24.1090000 10.7150000 2.6790000 + 368 368 1 0.0000000 24.1090000 10.7150000 8.0360000 + 369 369 1 0.0000000 24.1090000 10.7150000 13.3940000 + 370 370 1 0.0000000 24.1090000 10.7150000 18.7520000 + 371 371 1 0.0000000 24.1090000 10.7150000 24.1090000 + 372 372 1 0.0000000 24.1090000 10.7150000 29.4670000 + 373 373 1 0.0000000 24.1090000 16.0730000 2.6790000 + 374 374 1 0.0000000 24.1090000 16.0730000 8.0360000 + 375 375 1 0.0000000 24.1090000 16.0730000 13.3940000 + 376 376 1 0.0000000 24.1090000 16.0730000 18.7520000 + 377 377 1 0.0000000 24.1090000 16.0730000 24.1090000 + 378 378 1 0.0000000 24.1090000 16.0730000 29.4670000 + 379 379 1 0.0000000 24.1090000 21.4310000 2.6790000 + 380 380 1 0.0000000 24.1090000 21.4310000 8.0360000 + 381 381 1 0.0000000 24.1090000 21.4310000 13.3940000 + 382 382 1 0.0000000 24.1090000 21.4310000 18.7520000 + 383 383 1 0.0000000 24.1090000 21.4310000 24.1090000 + 384 384 1 0.0000000 24.1090000 21.4310000 29.4670000 + 385 385 1 0.0000000 24.1090000 26.7880000 2.6790000 + 386 386 1 0.0000000 24.1090000 26.7880000 8.0360000 + 387 387 1 0.0000000 24.1090000 26.7880000 13.3940000 + 388 388 1 0.0000000 24.1090000 26.7880000 18.7520000 + 389 389 1 0.0000000 24.1090000 26.7880000 24.1090000 + 390 390 1 0.0000000 24.1090000 26.7880000 29.4670000 + 391 391 1 0.0000000 24.1090000 32.1460000 2.6790000 + 392 392 1 0.0000000 24.1090000 32.1460000 8.0360000 + 393 393 1 0.0000000 24.1090000 32.1460000 13.3940000 + 394 394 1 0.0000000 24.1090000 32.1460000 18.7520000 + 395 395 1 0.0000000 24.1090000 32.1460000 24.1090000 + 396 396 1 0.0000000 24.1090000 32.1460000 29.4670000 + 397 397 1 0.0000000 29.4670000 5.3580000 2.6790000 + 398 398 1 0.0000000 29.4670000 5.3580000 8.0360000 + 399 399 1 0.0000000 29.4670000 5.3580000 13.3940000 + 400 400 1 0.0000000 29.4670000 5.3580000 18.7520000 + 401 401 1 0.0000000 29.4670000 5.3580000 24.1090000 + 402 402 1 0.0000000 29.4670000 5.3580000 29.4670000 + 403 403 1 0.0000000 29.4670000 10.7150000 2.6790000 + 404 404 1 0.0000000 29.4670000 10.7150000 8.0360000 + 405 405 1 0.0000000 29.4670000 10.7150000 13.3940000 + 406 406 1 0.0000000 29.4670000 10.7150000 18.7520000 + 407 407 1 0.0000000 29.4670000 10.7150000 24.1090000 + 408 408 1 0.0000000 29.4670000 10.7150000 29.4670000 + 409 409 1 0.0000000 29.4670000 16.0730000 2.6790000 + 410 410 1 0.0000000 29.4670000 16.0730000 8.0360000 + 411 411 1 0.0000000 29.4670000 16.0730000 13.3940000 + 412 412 1 0.0000000 29.4670000 16.0730000 18.7520000 + 413 413 1 0.0000000 29.4670000 16.0730000 24.1090000 + 414 414 1 0.0000000 29.4670000 16.0730000 29.4670000 + 415 415 1 0.0000000 29.4670000 21.4310000 2.6790000 + 416 416 1 0.0000000 29.4670000 21.4310000 8.0360000 + 417 417 1 0.0000000 29.4670000 21.4310000 13.3940000 + 418 418 1 0.0000000 29.4670000 21.4310000 18.7520000 + 419 419 1 0.0000000 29.4670000 21.4310000 24.1090000 + 420 420 1 0.0000000 29.4670000 21.4310000 29.4670000 + 421 421 1 0.0000000 29.4670000 26.7880000 2.6790000 + 422 422 1 0.0000000 29.4670000 26.7880000 8.0360000 + 423 423 1 0.0000000 29.4670000 26.7880000 13.3940000 + 424 424 1 0.0000000 29.4670000 26.7880000 18.7520000 + 425 425 1 0.0000000 29.4670000 26.7880000 24.1090000 + 426 426 1 0.0000000 29.4670000 26.7880000 29.4670000 + 427 427 1 0.0000000 29.4670000 32.1460000 2.6790000 + 428 428 1 0.0000000 29.4670000 32.1460000 8.0360000 + 429 429 1 0.0000000 29.4670000 32.1460000 13.3940000 + 430 430 1 0.0000000 29.4670000 32.1460000 18.7520000 + 431 431 1 0.0000000 29.4670000 32.1460000 24.1090000 + 432 432 1 0.0000000 29.4670000 32.1460000 29.4670000 + 433 433 1 0.0000000 2.6790000 2.6790000 5.3580000 + 434 434 1 0.0000000 2.6790000 2.6790000 10.7150000 + 435 435 1 0.0000000 2.6790000 2.6790000 16.0730000 + 436 436 1 0.0000000 2.6790000 2.6790000 21.4310000 + 437 437 1 0.0000000 2.6790000 2.6790000 26.7880000 + 438 438 1 0.0000000 2.6790000 2.6790000 32.1460000 + 439 439 1 0.0000000 2.6790000 8.0360000 5.3580000 + 440 440 1 0.0000000 2.6790000 8.0360000 10.7150000 + 441 441 1 0.0000000 2.6790000 8.0360000 16.0730000 + 442 442 1 0.0000000 2.6790000 8.0360000 21.4310000 + 443 443 1 0.0000000 2.6790000 8.0360000 26.7880000 + 444 444 1 0.0000000 2.6790000 8.0360000 32.1460000 + 445 445 1 0.0000000 2.6790000 13.3940000 5.3580000 + 446 446 1 0.0000000 2.6790000 13.3940000 10.7150000 + 447 447 1 0.0000000 2.6790000 13.3940000 16.0730000 + 448 448 1 0.0000000 2.6790000 13.3940000 21.4310000 + 449 449 1 0.0000000 2.6790000 13.3940000 26.7880000 + 450 450 1 0.0000000 2.6790000 13.3940000 32.1460000 + 451 451 1 0.0000000 2.6790000 18.7520000 5.3580000 + 452 452 1 0.0000000 2.6790000 18.7520000 10.7150000 + 453 453 1 0.0000000 2.6790000 18.7520000 16.0730000 + 454 454 1 0.0000000 2.6790000 18.7520000 21.4310000 + 455 455 1 0.0000000 2.6790000 18.7520000 26.7880000 + 456 456 1 0.0000000 2.6790000 18.7520000 32.1460000 + 457 457 1 0.0000000 2.6790000 24.1090000 5.3580000 + 458 458 1 0.0000000 2.6790000 24.1090000 10.7150000 + 459 459 1 0.0000000 2.6790000 24.1090000 16.0730000 + 460 460 1 0.0000000 2.6790000 24.1090000 21.4310000 + 461 461 1 0.0000000 2.6790000 24.1090000 26.7880000 + 462 462 1 0.0000000 2.6790000 24.1090000 32.1460000 + 463 463 1 0.0000000 2.6790000 29.4670000 5.3580000 + 464 464 1 0.0000000 2.6790000 29.4670000 10.7150000 + 465 465 1 0.0000000 2.6790000 29.4670000 16.0730000 + 466 466 1 0.0000000 2.6790000 29.4670000 21.4310000 + 467 467 1 0.0000000 2.6790000 29.4670000 26.7880000 + 468 468 1 0.0000000 2.6790000 29.4670000 32.1460000 + 469 469 1 0.0000000 8.0360000 2.6790000 5.3580000 + 470 470 1 0.0000000 8.0360000 2.6790000 10.7150000 + 471 471 1 0.0000000 8.0360000 2.6790000 16.0730000 + 472 472 1 0.0000000 8.0360000 2.6790000 21.4310000 + 473 473 1 0.0000000 8.0360000 2.6790000 26.7880000 + 474 474 1 0.0000000 8.0360000 2.6790000 32.1460000 + 475 475 1 0.0000000 8.0360000 8.0360000 5.3580000 + 476 476 1 0.0000000 8.0360000 8.0360000 10.7150000 + 477 477 1 0.0000000 8.0360000 8.0360000 16.0730000 + 478 478 1 0.0000000 8.0360000 8.0360000 21.4310000 + 479 479 1 0.0000000 8.0360000 8.0360000 26.7880000 + 480 480 1 0.0000000 8.0360000 8.0360000 32.1460000 + 481 481 1 0.0000000 8.0360000 13.3940000 5.3580000 + 482 482 1 0.0000000 8.0360000 13.3940000 10.7150000 + 483 483 1 0.0000000 8.0360000 13.3940000 16.0730000 + 484 484 1 0.0000000 8.0360000 13.3940000 21.4310000 + 485 485 1 0.0000000 8.0360000 13.3940000 26.7880000 + 486 486 1 0.0000000 8.0360000 13.3940000 32.1460000 + 487 487 1 0.0000000 8.0360000 18.7520000 5.3580000 + 488 488 1 0.0000000 8.0360000 18.7520000 10.7150000 + 489 489 1 0.0000000 8.0360000 18.7520000 16.0730000 + 490 490 1 0.0000000 8.0360000 18.7520000 21.4310000 + 491 491 1 0.0000000 8.0360000 18.7520000 26.7880000 + 492 492 1 0.0000000 8.0360000 18.7520000 32.1460000 + 493 493 1 0.0000000 8.0360000 24.1090000 5.3580000 + 494 494 1 0.0000000 8.0360000 24.1090000 10.7150000 + 495 495 1 0.0000000 8.0360000 24.1090000 16.0730000 + 496 496 1 0.0000000 8.0360000 24.1090000 21.4310000 + 497 497 1 0.0000000 8.0360000 24.1090000 26.7880000 + 498 498 1 0.0000000 8.0360000 24.1090000 32.1460000 + 499 499 1 0.0000000 8.0360000 29.4670000 5.3580000 + 500 500 1 0.0000000 8.0360000 29.4670000 10.7150000 + 501 501 1 0.0000000 8.0360000 29.4670000 16.0730000 + 502 502 1 0.0000000 8.0360000 29.4670000 21.4310000 + 503 503 1 0.0000000 8.0360000 29.4670000 26.7880000 + 504 504 1 0.0000000 8.0360000 29.4670000 32.1460000 + 505 505 1 0.0000000 13.3940000 2.6790000 5.3580000 + 506 506 1 0.0000000 13.3940000 2.6790000 10.7150000 + 507 507 1 0.0000000 13.3940000 2.6790000 16.0730000 + 508 508 1 0.0000000 13.3940000 2.6790000 21.4310000 + 509 509 1 0.0000000 13.3940000 2.6790000 26.7880000 + 510 510 1 0.0000000 13.3940000 2.6790000 32.1460000 + 511 511 1 0.0000000 13.3940000 8.0360000 5.3580000 + 512 512 1 0.0000000 13.3940000 8.0360000 10.7150000 + 513 513 1 0.0000000 13.3940000 8.0360000 16.0730000 + 514 514 1 0.0000000 13.3940000 8.0360000 21.4310000 + 515 515 1 0.0000000 13.3940000 8.0360000 26.7880000 + 516 516 1 0.0000000 13.3940000 8.0360000 32.1460000 + 517 517 1 0.0000000 13.3940000 13.3940000 5.3580000 + 518 518 1 0.0000000 13.3940000 13.3940000 10.7150000 + 519 519 1 0.0000000 13.3940000 13.3940000 16.0730000 + 520 520 1 0.0000000 13.3940000 13.3940000 21.4310000 + 521 521 1 0.0000000 13.3940000 13.3940000 26.7880000 + 522 522 1 0.0000000 13.3940000 13.3940000 32.1460000 + 523 523 1 0.0000000 13.3940000 18.7520000 5.3580000 + 524 524 1 0.0000000 13.3940000 18.7520000 10.7150000 + 525 525 1 0.0000000 13.3940000 18.7520000 16.0730000 + 526 526 1 0.0000000 13.3940000 18.7520000 21.4310000 + 527 527 1 0.0000000 13.3940000 18.7520000 26.7880000 + 528 528 1 0.0000000 13.3940000 18.7520000 32.1460000 + 529 529 1 0.0000000 13.3940000 24.1090000 5.3580000 + 530 530 1 0.0000000 13.3940000 24.1090000 10.7150000 + 531 531 1 0.0000000 13.3940000 24.1090000 16.0730000 + 532 532 1 0.0000000 13.3940000 24.1090000 21.4310000 + 533 533 1 0.0000000 13.3940000 24.1090000 26.7880000 + 534 534 1 0.0000000 13.3940000 24.1090000 32.1460000 + 535 535 1 0.0000000 13.3940000 29.4670000 5.3580000 + 536 536 1 0.0000000 13.3940000 29.4670000 10.7150000 + 537 537 1 0.0000000 13.3940000 29.4670000 16.0730000 + 538 538 1 0.0000000 13.3940000 29.4670000 21.4310000 + 539 539 1 0.0000000 13.3940000 29.4670000 26.7880000 + 540 540 1 0.0000000 13.3940000 29.4670000 32.1460000 + 541 541 1 0.0000000 18.7520000 2.6790000 5.3580000 + 542 542 1 0.0000000 18.7520000 2.6790000 10.7150000 + 543 543 1 0.0000000 18.7520000 2.6790000 16.0730000 + 544 544 1 0.0000000 18.7520000 2.6790000 21.4310000 + 545 545 1 0.0000000 18.7520000 2.6790000 26.7880000 + 546 546 1 0.0000000 18.7520000 2.6790000 32.1460000 + 547 547 1 0.0000000 18.7520000 8.0360000 5.3580000 + 548 548 1 0.0000000 18.7520000 8.0360000 10.7150000 + 549 549 1 0.0000000 18.7520000 8.0360000 16.0730000 + 550 550 1 0.0000000 18.7520000 8.0360000 21.4310000 + 551 551 1 0.0000000 18.7520000 8.0360000 26.7880000 + 552 552 1 0.0000000 18.7520000 8.0360000 32.1460000 + 553 553 1 0.0000000 18.7520000 13.3940000 5.3580000 + 554 554 1 0.0000000 18.7520000 13.3940000 10.7150000 + 555 555 1 0.0000000 18.7520000 13.3940000 16.0730000 + 556 556 1 0.0000000 18.7520000 13.3940000 21.4310000 + 557 557 1 0.0000000 18.7520000 13.3940000 26.7880000 + 558 558 1 0.0000000 18.7520000 13.3940000 32.1460000 + 559 559 1 0.0000000 18.7520000 18.7520000 5.3580000 + 560 560 1 0.0000000 18.7520000 18.7520000 10.7150000 + 561 561 1 0.0000000 18.7520000 18.7520000 16.0730000 + 562 562 1 0.0000000 18.7520000 18.7520000 21.4310000 + 563 563 1 0.0000000 18.7520000 18.7520000 26.7880000 + 564 564 1 0.0000000 18.7520000 18.7520000 32.1460000 + 565 565 1 0.0000000 18.7520000 24.1090000 5.3580000 + 566 566 1 0.0000000 18.7520000 24.1090000 10.7150000 + 567 567 1 0.0000000 18.7520000 24.1090000 16.0730000 + 568 568 1 0.0000000 18.7520000 24.1090000 21.4310000 + 569 569 1 0.0000000 18.7520000 24.1090000 26.7880000 + 570 570 1 0.0000000 18.7520000 24.1090000 32.1460000 + 571 571 1 0.0000000 18.7520000 29.4670000 5.3580000 + 572 572 1 0.0000000 18.7520000 29.4670000 10.7150000 + 573 573 1 0.0000000 18.7520000 29.4670000 16.0730000 + 574 574 1 0.0000000 18.7520000 29.4670000 21.4310000 + 575 575 1 0.0000000 18.7520000 29.4670000 26.7880000 + 576 576 1 0.0000000 18.7520000 29.4670000 32.1460000 + 577 577 1 0.0000000 24.1090000 2.6790000 5.3580000 + 578 578 1 0.0000000 24.1090000 2.6790000 10.7150000 + 579 579 1 0.0000000 24.1090000 2.6790000 16.0730000 + 580 580 1 0.0000000 24.1090000 2.6790000 21.4310000 + 581 581 1 0.0000000 24.1090000 2.6790000 26.7880000 + 582 582 1 0.0000000 24.1090000 2.6790000 32.1460000 + 583 583 1 0.0000000 24.1090000 8.0360000 5.3580000 + 584 584 1 0.0000000 24.1090000 8.0360000 10.7150000 + 585 585 1 0.0000000 24.1090000 8.0360000 16.0730000 + 586 586 1 0.0000000 24.1090000 8.0360000 21.4310000 + 587 587 1 0.0000000 24.1090000 8.0360000 26.7880000 + 588 588 1 0.0000000 24.1090000 8.0360000 32.1460000 + 589 589 1 0.0000000 24.1090000 13.3940000 5.3580000 + 590 590 1 0.0000000 24.1090000 13.3940000 10.7150000 + 591 591 1 0.0000000 24.1090000 13.3940000 16.0730000 + 592 592 1 0.0000000 24.1090000 13.3940000 21.4310000 + 593 593 1 0.0000000 24.1090000 13.3940000 26.7880000 + 594 594 1 0.0000000 24.1090000 13.3940000 32.1460000 + 595 595 1 0.0000000 24.1090000 18.7520000 5.3580000 + 596 596 1 0.0000000 24.1090000 18.7520000 10.7150000 + 597 597 1 0.0000000 24.1090000 18.7520000 16.0730000 + 598 598 1 0.0000000 24.1090000 18.7520000 21.4310000 + 599 599 1 0.0000000 24.1090000 18.7520000 26.7880000 + 600 600 1 0.0000000 24.1090000 18.7520000 32.1460000 + 601 601 1 0.0000000 24.1090000 24.1090000 5.3580000 + 602 602 1 0.0000000 24.1090000 24.1090000 10.7150000 + 603 603 1 0.0000000 24.1090000 24.1090000 16.0730000 + 604 604 1 0.0000000 24.1090000 24.1090000 21.4310000 + 605 605 1 0.0000000 24.1090000 24.1090000 26.7880000 + 606 606 1 0.0000000 24.1090000 24.1090000 32.1460000 + 607 607 1 0.0000000 24.1090000 29.4670000 5.3580000 + 608 608 1 0.0000000 24.1090000 29.4670000 10.7150000 + 609 609 1 0.0000000 24.1090000 29.4670000 16.0730000 + 610 610 1 0.0000000 24.1090000 29.4670000 21.4310000 + 611 611 1 0.0000000 24.1090000 29.4670000 26.7880000 + 612 612 1 0.0000000 24.1090000 29.4670000 32.1460000 + 613 613 1 0.0000000 29.4670000 2.6790000 5.3580000 + 614 614 1 0.0000000 29.4670000 2.6790000 10.7150000 + 615 615 1 0.0000000 29.4670000 2.6790000 16.0730000 + 616 616 1 0.0000000 29.4670000 2.6790000 21.4310000 + 617 617 1 0.0000000 29.4670000 2.6790000 26.7880000 + 618 618 1 0.0000000 29.4670000 2.6790000 32.1460000 + 619 619 1 0.0000000 29.4670000 8.0360000 5.3580000 + 620 620 1 0.0000000 29.4670000 8.0360000 10.7150000 + 621 621 1 0.0000000 29.4670000 8.0360000 16.0730000 + 622 622 1 0.0000000 29.4670000 8.0360000 21.4310000 + 623 623 1 0.0000000 29.4670000 8.0360000 26.7880000 + 624 624 1 0.0000000 29.4670000 8.0360000 32.1460000 + 625 625 1 0.0000000 29.4670000 13.3940000 5.3580000 + 626 626 1 0.0000000 29.4670000 13.3940000 10.7150000 + 627 627 1 0.0000000 29.4670000 13.3940000 16.0730000 + 628 628 1 0.0000000 29.4670000 13.3940000 21.4310000 + 629 629 1 0.0000000 29.4670000 13.3940000 26.7880000 + 630 630 1 0.0000000 29.4670000 13.3940000 32.1460000 + 631 631 1 0.0000000 29.4670000 18.7520000 5.3580000 + 632 632 1 0.0000000 29.4670000 18.7520000 10.7150000 + 633 633 1 0.0000000 29.4670000 18.7520000 16.0730000 + 634 634 1 0.0000000 29.4670000 18.7520000 21.4310000 + 635 635 1 0.0000000 29.4670000 18.7520000 26.7880000 + 636 636 1 0.0000000 29.4670000 18.7520000 32.1460000 + 637 637 1 0.0000000 29.4670000 24.1090000 5.3580000 + 638 638 1 0.0000000 29.4670000 24.1090000 10.7150000 + 639 639 1 0.0000000 29.4670000 24.1090000 16.0730000 + 640 640 1 0.0000000 29.4670000 24.1090000 21.4310000 + 641 641 1 0.0000000 29.4670000 24.1090000 26.7880000 + 642 642 1 0.0000000 29.4670000 24.1090000 32.1460000 + 643 643 1 0.0000000 29.4670000 29.4670000 5.3580000 + 644 644 1 0.0000000 29.4670000 29.4670000 10.7150000 + 645 645 1 0.0000000 29.4670000 29.4670000 16.0730000 + 646 646 1 0.0000000 29.4670000 29.4670000 21.4310000 + 647 647 1 0.0000000 29.4670000 29.4670000 26.7880000 + 648 648 1 0.0000000 29.4670000 29.4670000 32.1460000 + 649 649 1 0.0000000 0.0000000 5.3580000 5.3580000 + 650 650 1 0.0000000 0.0000000 5.3580000 10.7150000 + 651 651 1 0.0000000 0.0000000 5.3580000 16.0730000 + 652 652 1 0.0000000 0.0000000 5.3580000 21.4310000 + 653 653 1 0.0000000 0.0000000 5.3580000 26.7880000 + 654 654 1 0.0000000 0.0000000 5.3580000 32.1460000 + 655 655 1 0.0000000 0.0000000 10.7150000 5.3580000 + 656 656 1 0.0000000 0.0000000 10.7150000 10.7150000 + 657 657 1 0.0000000 0.0000000 10.7150000 16.0730000 + 658 658 1 0.0000000 0.0000000 10.7150000 21.4310000 + 659 659 1 0.0000000 0.0000000 10.7150000 26.7880000 + 660 660 1 0.0000000 0.0000000 10.7150000 32.1460000 + 661 661 1 0.0000000 0.0000000 16.0730000 5.3580000 + 662 662 1 0.0000000 0.0000000 16.0730000 10.7150000 + 663 663 1 0.0000000 0.0000000 16.0730000 16.0730000 + 664 664 1 0.0000000 0.0000000 16.0730000 21.4310000 + 665 665 1 0.0000000 0.0000000 16.0730000 26.7880000 + 666 666 1 0.0000000 0.0000000 16.0730000 32.1460000 + 667 667 1 0.0000000 0.0000000 21.4310000 5.3580000 + 668 668 1 0.0000000 0.0000000 21.4310000 10.7150000 + 669 669 1 0.0000000 0.0000000 21.4310000 16.0730000 + 670 670 1 0.0000000 0.0000000 21.4310000 21.4310000 + 671 671 1 0.0000000 0.0000000 21.4310000 26.7880000 + 672 672 1 0.0000000 0.0000000 21.4310000 32.1460000 + 673 673 1 0.0000000 0.0000000 26.7880000 5.3580000 + 674 674 1 0.0000000 0.0000000 26.7880000 10.7150000 + 675 675 1 0.0000000 0.0000000 26.7880000 16.0730000 + 676 676 1 0.0000000 0.0000000 26.7880000 21.4310000 + 677 677 1 0.0000000 0.0000000 26.7880000 26.7880000 + 678 678 1 0.0000000 0.0000000 26.7880000 32.1460000 + 679 679 1 0.0000000 0.0000000 32.1460000 5.3580000 + 680 680 1 0.0000000 0.0000000 32.1460000 10.7150000 + 681 681 1 0.0000000 0.0000000 32.1460000 16.0730000 + 682 682 1 0.0000000 0.0000000 32.1460000 21.4310000 + 683 683 1 0.0000000 0.0000000 32.1460000 26.7880000 + 684 684 1 0.0000000 0.0000000 32.1460000 32.1460000 + 685 685 1 0.0000000 5.3580000 5.3580000 5.3580000 + 686 686 1 0.0000000 5.3580000 5.3580000 10.7150000 + 687 687 1 0.0000000 5.3580000 5.3580000 16.0730000 + 688 688 1 0.0000000 5.3580000 5.3580000 21.4310000 + 689 689 1 0.0000000 5.3580000 5.3580000 26.7880000 + 690 690 1 0.0000000 5.3580000 5.3580000 32.1460000 + 691 691 1 0.0000000 5.3580000 10.7150000 5.3580000 + 692 692 1 0.0000000 5.3580000 10.7150000 10.7150000 + 693 693 1 0.0000000 5.3580000 10.7150000 16.0730000 + 694 694 1 0.0000000 5.3580000 10.7150000 21.4310000 + 695 695 1 0.0000000 5.3580000 10.7150000 26.7880000 + 696 696 1 0.0000000 5.3580000 10.7150000 32.1460000 + 697 697 1 0.0000000 5.3580000 16.0730000 5.3580000 + 698 698 1 0.0000000 5.3580000 16.0730000 10.7150000 + 699 699 1 0.0000000 5.3580000 16.0730000 16.0730000 + 700 700 1 0.0000000 5.3580000 16.0730000 21.4310000 + 701 701 1 0.0000000 5.3580000 16.0730000 26.7880000 + 702 702 1 0.0000000 5.3580000 16.0730000 32.1460000 + 703 703 1 0.0000000 5.3580000 21.4310000 5.3580000 + 704 704 1 0.0000000 5.3580000 21.4310000 10.7150000 + 705 705 1 0.0000000 5.3580000 21.4310000 16.0730000 + 706 706 1 0.0000000 5.3580000 21.4310000 21.4310000 + 707 707 1 0.0000000 5.3580000 21.4310000 26.7880000 + 708 708 1 0.0000000 5.3580000 21.4310000 32.1460000 + 709 709 1 0.0000000 5.3580000 26.7880000 5.3580000 + 710 710 1 0.0000000 5.3580000 26.7880000 10.7150000 + 711 711 1 0.0000000 5.3580000 26.7880000 16.0730000 + 712 712 1 0.0000000 5.3580000 26.7880000 21.4310000 + 713 713 1 0.0000000 5.3580000 26.7880000 26.7880000 + 714 714 1 0.0000000 5.3580000 26.7880000 32.1460000 + 715 715 1 0.0000000 5.3580000 32.1460000 5.3580000 + 716 716 1 0.0000000 5.3580000 32.1460000 10.7150000 + 717 717 1 0.0000000 5.3580000 32.1460000 16.0730000 + 718 718 1 0.0000000 5.3580000 32.1460000 21.4310000 + 719 719 1 0.0000000 5.3580000 32.1460000 26.7880000 + 720 720 1 0.0000000 5.3580000 32.1460000 32.1460000 + 721 721 1 0.0000000 10.7150000 5.3580000 5.3580000 + 722 722 1 0.0000000 10.7150000 5.3580000 10.7150000 + 723 723 1 0.0000000 10.7150000 5.3580000 16.0730000 + 724 724 1 0.0000000 10.7150000 5.3580000 21.4310000 + 725 725 1 0.0000000 10.7150000 5.3580000 26.7880000 + 726 726 1 0.0000000 10.7150000 5.3580000 32.1460000 + 727 727 1 0.0000000 10.7150000 10.7150000 5.3580000 + 728 728 1 0.0000000 10.7150000 10.7150000 10.7150000 + 729 729 1 0.0000000 10.7150000 10.7150000 16.0730000 + 730 730 1 0.0000000 10.7150000 10.7150000 21.4310000 + 731 731 1 0.0000000 10.7150000 10.7150000 26.7880000 + 732 732 1 0.0000000 10.7150000 10.7150000 32.1460000 + 733 733 1 0.0000000 10.7150000 16.0730000 5.3580000 + 734 734 1 0.0000000 10.7150000 16.0730000 10.7150000 + 735 735 1 0.0000000 10.7150000 16.0730000 16.0730000 + 736 736 1 0.0000000 10.7150000 16.0730000 21.4310000 + 737 737 1 0.0000000 10.7150000 16.0730000 26.7880000 + 738 738 1 0.0000000 10.7150000 16.0730000 32.1460000 + 739 739 1 0.0000000 10.7150000 21.4310000 5.3580000 + 740 740 1 0.0000000 10.7150000 21.4310000 10.7150000 + 741 741 1 0.0000000 10.7150000 21.4310000 16.0730000 + 742 742 1 0.0000000 10.7150000 21.4310000 21.4310000 + 743 743 1 0.0000000 10.7150000 21.4310000 26.7880000 + 744 744 1 0.0000000 10.7150000 21.4310000 32.1460000 + 745 745 1 0.0000000 10.7150000 26.7880000 5.3580000 + 746 746 1 0.0000000 10.7150000 26.7880000 10.7150000 + 747 747 1 0.0000000 10.7150000 26.7880000 16.0730000 + 748 748 1 0.0000000 10.7150000 26.7880000 21.4310000 + 749 749 1 0.0000000 10.7150000 26.7880000 26.7880000 + 750 750 1 0.0000000 10.7150000 26.7880000 32.1460000 + 751 751 1 0.0000000 10.7150000 32.1460000 5.3580000 + 752 752 1 0.0000000 10.7150000 32.1460000 10.7150000 + 753 753 1 0.0000000 10.7150000 32.1460000 16.0730000 + 754 754 1 0.0000000 10.7150000 32.1460000 21.4310000 + 755 755 1 0.0000000 10.7150000 32.1460000 26.7880000 + 756 756 1 0.0000000 10.7150000 32.1460000 32.1460000 + 757 757 1 0.0000000 16.0730000 5.3580000 5.3580000 + 758 758 1 0.0000000 16.0730000 5.3580000 10.7150000 + 759 759 1 0.0000000 16.0730000 5.3580000 16.0730000 + 760 760 1 0.0000000 16.0730000 5.3580000 21.4310000 + 761 761 1 0.0000000 16.0730000 5.3580000 26.7880000 + 762 762 1 0.0000000 16.0730000 5.3580000 32.1460000 + 763 763 1 0.0000000 16.0730000 10.7150000 5.3580000 + 764 764 1 0.0000000 16.0730000 10.7150000 10.7150000 + 765 765 1 0.0000000 16.0730000 10.7150000 16.0730000 + 766 766 1 0.0000000 16.0730000 10.7150000 21.4310000 + 767 767 1 0.0000000 16.0730000 10.7150000 26.7880000 + 768 768 1 0.0000000 16.0730000 10.7150000 32.1460000 + 769 769 1 0.0000000 16.0730000 16.0730000 5.3580000 + 770 770 1 0.0000000 16.0730000 16.0730000 10.7150000 + 771 771 1 0.0000000 16.0730000 16.0730000 16.0730000 + 772 772 1 0.0000000 16.0730000 16.0730000 21.4310000 + 773 773 1 0.0000000 16.0730000 16.0730000 26.7880000 + 774 774 1 0.0000000 16.0730000 16.0730000 32.1460000 + 775 775 1 0.0000000 16.0730000 21.4310000 5.3580000 + 776 776 1 0.0000000 16.0730000 21.4310000 10.7150000 + 777 777 1 0.0000000 16.0730000 21.4310000 16.0730000 + 778 778 1 0.0000000 16.0730000 21.4310000 21.4310000 + 779 779 1 0.0000000 16.0730000 21.4310000 26.7880000 + 780 780 1 0.0000000 16.0730000 21.4310000 32.1460000 + 781 781 1 0.0000000 16.0730000 26.7880000 5.3580000 + 782 782 1 0.0000000 16.0730000 26.7880000 10.7150000 + 783 783 1 0.0000000 16.0730000 26.7880000 16.0730000 + 784 784 1 0.0000000 16.0730000 26.7880000 21.4310000 + 785 785 1 0.0000000 16.0730000 26.7880000 26.7880000 + 786 786 1 0.0000000 16.0730000 26.7880000 32.1460000 + 787 787 1 0.0000000 16.0730000 32.1460000 5.3580000 + 788 788 1 0.0000000 16.0730000 32.1460000 10.7150000 + 789 789 1 0.0000000 16.0730000 32.1460000 16.0730000 + 790 790 1 0.0000000 16.0730000 32.1460000 21.4310000 + 791 791 1 0.0000000 16.0730000 32.1460000 26.7880000 + 792 792 1 0.0000000 16.0730000 32.1460000 32.1460000 + 793 793 1 0.0000000 21.4310000 5.3580000 5.3580000 + 794 794 1 0.0000000 21.4310000 5.3580000 10.7150000 + 795 795 1 0.0000000 21.4310000 5.3580000 16.0730000 + 796 796 1 0.0000000 21.4310000 5.3580000 21.4310000 + 797 797 1 0.0000000 21.4310000 5.3580000 26.7880000 + 798 798 1 0.0000000 21.4310000 5.3580000 32.1460000 + 799 799 1 0.0000000 21.4310000 10.7150000 5.3580000 + 800 800 1 0.0000000 21.4310000 10.7150000 10.7150000 + 801 801 1 0.0000000 21.4310000 10.7150000 16.0730000 + 802 802 1 0.0000000 21.4310000 10.7150000 21.4310000 + 803 803 1 0.0000000 21.4310000 10.7150000 26.7880000 + 804 804 1 0.0000000 21.4310000 10.7150000 32.1460000 + 805 805 1 0.0000000 21.4310000 16.0730000 5.3580000 + 806 806 1 0.0000000 21.4310000 16.0730000 10.7150000 + 807 807 1 0.0000000 21.4310000 16.0730000 16.0730000 + 808 808 1 0.0000000 21.4310000 16.0730000 21.4310000 + 809 809 1 0.0000000 21.4310000 16.0730000 26.7880000 + 810 810 1 0.0000000 21.4310000 16.0730000 32.1460000 + 811 811 1 0.0000000 21.4310000 21.4310000 5.3580000 + 812 812 1 0.0000000 21.4310000 21.4310000 10.7150000 + 813 813 1 0.0000000 21.4310000 21.4310000 16.0730000 + 814 814 1 0.0000000 21.4310000 21.4310000 21.4310000 + 815 815 1 0.0000000 21.4310000 21.4310000 26.7880000 + 816 816 1 0.0000000 21.4310000 21.4310000 32.1460000 + 817 817 1 0.0000000 21.4310000 26.7880000 5.3580000 + 818 818 1 0.0000000 21.4310000 26.7880000 10.7150000 + 819 819 1 0.0000000 21.4310000 26.7880000 16.0730000 + 820 820 1 0.0000000 21.4310000 26.7880000 21.4310000 + 821 821 1 0.0000000 21.4310000 26.7880000 26.7880000 + 822 822 1 0.0000000 21.4310000 26.7880000 32.1460000 + 823 823 1 0.0000000 21.4310000 32.1460000 5.3580000 + 824 824 1 0.0000000 21.4310000 32.1460000 10.7150000 + 825 825 1 0.0000000 21.4310000 32.1460000 16.0730000 + 826 826 1 0.0000000 21.4310000 32.1460000 21.4310000 + 827 827 1 0.0000000 21.4310000 32.1460000 26.7880000 + 828 828 1 0.0000000 21.4310000 32.1460000 32.1460000 + 829 829 1 0.0000000 26.7880000 5.3580000 5.3580000 + 830 830 1 0.0000000 26.7880000 5.3580000 10.7150000 + 831 831 1 0.0000000 26.7880000 5.3580000 16.0730000 + 832 832 1 0.0000000 26.7880000 5.3580000 21.4310000 + 833 833 1 0.0000000 26.7880000 5.3580000 26.7880000 + 834 834 1 0.0000000 26.7880000 5.3580000 32.1460000 + 835 835 1 0.0000000 26.7880000 10.7150000 5.3580000 + 836 836 1 0.0000000 26.7880000 10.7150000 10.7150000 + 837 837 1 0.0000000 26.7880000 10.7150000 16.0730000 + 838 838 1 0.0000000 26.7880000 10.7150000 21.4310000 + 839 839 1 0.0000000 26.7880000 10.7150000 26.7880000 + 840 840 1 0.0000000 26.7880000 10.7150000 32.1460000 + 841 841 1 0.0000000 26.7880000 16.0730000 5.3580000 + 842 842 1 0.0000000 26.7880000 16.0730000 10.7150000 + 843 843 1 0.0000000 26.7880000 16.0730000 16.0730000 + 844 844 1 0.0000000 26.7880000 16.0730000 21.4310000 + 845 845 1 0.0000000 26.7880000 16.0730000 26.7880000 + 846 846 1 0.0000000 26.7880000 16.0730000 32.1460000 + 847 847 1 0.0000000 26.7880000 21.4310000 5.3580000 + 848 848 1 0.0000000 26.7880000 21.4310000 10.7150000 + 849 849 1 0.0000000 26.7880000 21.4310000 16.0730000 + 850 850 1 0.0000000 26.7880000 21.4310000 21.4310000 + 851 851 1 0.0000000 26.7880000 21.4310000 26.7880000 + 852 852 1 0.0000000 26.7880000 21.4310000 32.1460000 + 853 853 1 0.0000000 26.7880000 26.7880000 5.3580000 + 854 854 1 0.0000000 26.7880000 26.7880000 10.7150000 + 855 855 1 0.0000000 26.7880000 26.7880000 16.0730000 + 856 856 1 0.0000000 26.7880000 26.7880000 21.4310000 + 857 857 1 0.0000000 26.7880000 26.7880000 26.7880000 + 858 858 1 0.0000000 26.7880000 26.7880000 32.1460000 + 859 859 1 0.0000000 26.7880000 32.1460000 5.3580000 + 860 860 1 0.0000000 26.7880000 32.1460000 10.7150000 + 861 861 1 0.0000000 26.7880000 32.1460000 16.0730000 + 862 862 1 0.0000000 26.7880000 32.1460000 21.4310000 + 863 863 1 0.0000000 26.7880000 32.1460000 26.7880000 + 864 864 1 0.0000000 26.7880000 32.1460000 32.1460000 + diff --git a/examples/gjf/ff-argon.lmp b/examples/gjf/ff-argon.lmp new file mode 100644 index 0000000000..b6f7bc931a --- /dev/null +++ b/examples/gjf/ff-argon.lmp @@ -0,0 +1,20 @@ +############################# +#Atoms types - mass - charge# +############################# +#@ 1 atom types #!THIS LINE IS NECESSARY DON'T SPEND HOURS FINDING THAT OUT!# + +variable Ar equal 1 + +############# +#Atom Masses# +############# + +mass ${Ar} 39.903 + +########################### +#Pair Potentials - Tersoff# +########################### + +pair_style lj/cubic +pair_coeff * * 0.0102701 3.42 + diff --git a/examples/gjf/in.argon b/examples/gjf/in.argon new file mode 100644 index 0000000000..271882c665 --- /dev/null +++ b/examples/gjf/in.argon @@ -0,0 +1,162 @@ +###############################mm +# Atom style - charge/vdw/bonded# +################################# +atom_style full + +############################################## +#Units Metal : eV - ps - angstrom - bar# +# Real : kcal/mol - fs - angstrom - atm# +############################################## +units metal + +############ +#Run number# +############ +variable run_no equal 0 # is it a restart? +variable res_no equal ${run_no}-1 # restart file number + +####################################### +#Random Seeds and Domain Decomposition# +####################################### +variable iseed0 equal 2357 +variable iseed1 equal 26488 +variable iseed2 equal 10669 +processors * * * + +########### +#Data File# +########### +variable inpfile string argon.lmp +variable resfile string final_restart.${res_no} +variable ff_file string ff-argon.lmp + +########## +#Run Type# +########## +variable minimise equal 0 #Energy Minimization +variable md equal 1 #Plain MD + +############################### +#Molecular Dynamics Parameters# +############################### +variable run_no equal 0 # is it a restart? + +variable ens equal 9 # ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres, 7=stoch, 8=gjf) +variable ts equal 0.120 # simulation timestep (time units) +variable nequil equal 0 # number of equilibration steps +variable nsteps equal 200000 # number of MD steps +#variable nsteps equal 20 # number of MD steps + +variable temp_s equal 10 # starting temperature +variable temp_f equal 10 # final simulation temperature +variable trel equal 1 # thermostat relaxation time +variable tscale equal 1 # thermostat relaxation freq - vel rescaling only +variable deltat equal 1 # maximum temperature change - vel rescaling only + +variable npttype string iso # type of NPT (iso, aniso, tri, z...) +variable pres equal 1.01325 # pressure (NPT runs only) +variable prel equal 1.0 # barostat relaxation time + +neighbor 1 bin + +################### +#Output Parameters# +################### +variable ntraj equal 1000 # trajectory output frequency - all system +variable ntraj_s equal -100 # trajectory output frequency - solute only +variable nthermo equal 200 # thermodynamic data output frequency + +################################ +#Energy Minimization Parameters# +################################ +variable mtraj equal 1 # trajectory output frequency - all system +variable etol equal 1e-5 # % change in energy +variable ftol equal 1e-5 # max force threshold (force units) +variable maxiter equal 10000 # max # of iterations + +######################## +#3D Periodic Simulation# +######################## +boundary p p p + +############################# +#Reading the input structure# +############################# +if "${run_no} == 0" then "read_data ${inpfile}" else "read_restart ${resfile}" + +############# +#Force Field# +############# +include ${ff_file} + +###################### +#Thermodynamic Output# +###################### +variable str_basic string 'step time pe temp press' + +#MD ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres) +variable str_ens string ' ' +if "${ens} == 0" then "variable str_ens string 'etotal'" +if "${ens} == 2" then "variable str_ens string 'vol pxx pyy pzz cella cellb cellc cellakpha cellbeta cellgamma'" + +#Variable for a gulp friend output +if "${ens} >= 0" then "thermo_style custom time temp pe etotal press vol cpu" & + "thermo ${nthermo}" & + "thermo_modify flush yes" + +##################### +#Energy Minimization# +##################### +if "${minimise} <= 0 || ${run_no} > 0" then "jump SELF end_minimise" + print "Doing CG minimisation" + dump mdcd all dcd ${mtraj} min.dcd + dump_modify mdcd unwrap yes + min_style cg + min_modify line quadratic + minimize ${etol} ${ftol} ${maxiter} ${maxiter} + reset_timestep 0 + undump mdcd +label end_minimise + +################ +#Timestep in ps# +################ +timestep ${ts} + +############## +#Restart file# +############## +restart 100000 restart.1 restart.2 + +################### +#Trajectory output# +################### +#dump xyz all atom 1000 silicon.lammpstrj + +if "${ntraj} > 0" then & + "dump 1 all dcd ${ntraj} trajectory.${run_no}.dcd" & + "dump_modify 1 unwrap yes" + +fix mom all momentum 1 linear 1 1 1 + +############################################################### +#Ensembles (0=nve,1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres)# +############################################################### +if "${md} > 0" then 'print "Setting up the ensembles"' & + 'if "${run_no} == 0" then "velocity all create ${temp_s} ${iseed0} mom yes dist gaussian"' & + 'if "${ens} == 0" then "fix nve all nve"' & + 'if "${ens} == 1" then "fix nvt all nvt temp ${temp_s} ${temp_f} ${trel} tchain 5"' & + 'if "${ens} == 2" then "fix npt all npt temp ${temp_s} ${temp_f} ${trel} ${npttype} ${pres} ${pres} ${prel} tchain 5 pchain 5 mtk yes"' & + 'if "${ens} == 3" then "fix nve all nve" "fix ber all temp/berendsen ${temp_s} ${temp_f} ${trel}"' & + 'if "${ens} == 4" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} tally yes zero yes"' & + 'if "${ens} == 5" then "fix nve all nve" "fix stoch all temp/csvr ${temp_s} ${temp_f} ${trel} ${iseed1}"' & + 'if "${ens} == 6" then "fix nve all nve" "fix stoch all temp/csld ${temp_s} ${temp_f} ${trel} ${iseed1}"' & + 'if "${ens} == 7" then "fix nve all nve" "fix vres all temp/rescale ${tscale} ${temp_s} ${temp_f} ${tmin} ${tmax}"' & + 'if "${ens} == 8" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes"' & + 'if "${ens} == 9" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes halfstep yes"' + +if "${md} > 0" then "print 'Doing Molecular dynamics'" & + "run ${nsteps}" & + "write_restart final_restart.${run_no}" + + diff --git a/examples/gjf/out.argon b/examples/gjf/out.argon new file mode 100644 index 0000000000..8dda569157 --- /dev/null +++ b/examples/gjf/out.argon @@ -0,0 +1,249 @@ +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 +Reading data file ... + orthogonal box = (0 0 0) to (32.146 32.146 32.146) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 864 atoms +Finding 1-2 1-3 1-4 neighbors ... + special bond factors lj: 0 0 0 + special bond factors coul: 0 0 0 + 0 = max # of 1-2 neighbors + 0 = max # of 1-3 neighbors + 0 = max # of 1-4 neighbors + 1 = max # of special neighbors +Setting up the ensembles +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) +Doing Molecular dynamics +Neighbor list info ... + update every 1 steps, delay 10 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.94072 + ghost atom cutoff = 6.94072 + binsize = 3.47036, bins = 10 10 10 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair lj/cubic, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard +Setting up Verlet run ... + Unit style : metal + Current step : 0 + Time step : 0.12 +Per MPI rank memory allocation (min/avg/max) = 6.847 | 6.847 | 6.847 Mbytes +Time Temp PotEng TotEng Press Volume CPU + 0 10 -56.207655 -55.09214 33.340921 33218.561 0 + 24 10.156356 -55.092888 -53.959932 339.40964 33218.561 0.082175482 + 48 9.6121006 -55.07262 -54.000376 344.56765 33218.561 0.19529325 + 72 9.8187467 -55.16687 -54.071574 318.85979 33218.561 0.29643488 + 96 9.5421385 -55.151229 -54.086789 322.8842 33218.561 0.38801357 + 120 10.295035 -55.12919 -53.980763 332.00171 33218.561 0.47607262 + 144 10.331608 -55.09907 -53.946563 339.28896 33218.561 0.57389224 + 168 10.154698 -55.058246 -53.925475 349.03253 33218.561 0.65481471 + 192 9.858198 -55.127583 -54.027886 330.09298 33218.561 0.74437734 + 216 9.6658918 -55.10812 -54.029875 334.28383 33218.561 0.8278495 + 240 9.6801591 -55.102386 -54.02255 336.27242 33218.561 0.91167379 + 264 10.685658 -55.046238 -53.854237 355.0448 33218.561 1.0023789 + 288 10.387727 -55.08427 -53.925504 343.87247 33218.561 1.0960371 + 312 10.231132 -55.120428 -53.97913 333.22463 33218.561 1.2382998 + 336 10.20896 -55.075142 -53.936317 344.88438 33218.561 1.3420489 + 360 9.7876538 -55.165008 -54.07318 319.14962 33218.561 1.42782 + 384 9.9872551 -55.13881 -54.024717 327.82471 33218.561 1.5417666 + 408 9.5362734 -55.063733 -53.999947 346.50545 33218.561 1.6328366 + 432 10.262638 -55.126608 -53.981796 332.16342 33218.561 1.7242996 + 456 9.9228239 -55.122119 -54.015214 332.26261 33218.561 1.8124888 + 480 9.7026324 -55.17057 -54.088227 317.84818 33218.561 1.900233 + 504 10.028762 -55.082465 -53.963741 343.04257 33218.561 1.989605 + 528 9.8227851 -55.121222 -54.025476 332.42857 33218.561 2.0708802 + 552 10.208672 -55.100242 -53.961449 338.68109 33218.561 2.1527217 + 576 10.180849 -55.124065 -53.988376 331.29516 33218.561 2.238126 + 600 9.6467252 -55.119533 -54.043427 332.43109 33218.561 2.323443 + 624 10.041885 -55.173802 -54.053614 318.48579 33218.561 2.4046151 + 648 10.151597 -55.111725 -53.979299 334.66227 33218.561 2.4902161 + 672 9.7719111 -55.060111 -53.970039 348.55249 33218.561 2.5800372 + 696 10.476688 -55.088109 -53.919419 342.94922 33218.561 2.6731395 + 720 10.517805 -55.113604 -53.940327 335.47342 33218.561 2.760651 + 744 10.006466 -55.045085 -53.928848 353.53813 33218.561 2.8537894 + 768 10.201492 -55.081598 -53.943606 343.3206 33218.561 2.9404115 + 792 10.117738 -55.077806 -53.949157 345.31093 33218.561 3.030765 + 816 10.362288 -55.11635 -53.960421 333.9045 33218.561 3.1177356 + 840 10.204164 -55.097619 -53.959329 338.82717 33218.561 3.2091886 + 864 10.147722 -55.101372 -53.969378 338.19682 33218.561 3.3003742 + 888 9.9265037 -55.111394 -54.004077 334.08116 33218.561 3.395341 + 912 10.206403 -55.132181 -53.993642 328.89904 33218.561 3.4882881 + 936 10.28639 -55.093317 -53.945855 340.61244 33218.561 3.5764735 + 960 9.8028822 -55.078802 -53.985276 343.5904 33218.561 3.7056267 + 984 10.492755 -55.121321 -53.950839 334.62697 33218.561 3.8055611 + 1008 10.621569 -55.088588 -53.903736 343.33166 33218.561 3.9144807 + 1032 10.006729 -55.113459 -53.997193 334.43025 33218.561 4.0189888 + 1056 10.099853 -55.068035 -53.941381 347.42158 33218.561 4.1391664 + 1080 10.254232 -55.066685 -53.92281 347.15777 33218.561 4.2443953 + 1104 9.9495142 -55.13686 -54.026977 327.63107 33218.561 4.3368342 + 1128 10.377108 -55.08846 -53.930878 344.13083 33218.561 4.4287748 + 1152 10.036981 -55.114643 -53.995003 334.88053 33218.561 4.526868 + 1176 10.144779 -55.097125 -53.965459 339.698 33218.561 4.6614049 + 1200 10.075844 -55.14695 -54.022974 326.05911 33218.561 4.799835 + 1224 10.183695 -55.121716 -53.98571 332.75772 33218.561 4.8908897 + 1248 10.581369 -55.027954 -53.847587 359.06251 33218.561 4.9839788 + 1272 10.158269 -55.105173 -53.972003 337.52964 33218.561 5.0918646 + 1296 9.8776072 -55.064085 -53.962223 347.15648 33218.561 5.2291209 + 1320 10.38161 -55.118366 -53.960282 335.17767 33218.561 5.3570446 + 1344 9.9528146 -55.141937 -54.031685 326.27117 33218.561 5.4584705 + 1368 9.8024326 -55.117808 -54.024332 332.99835 33218.561 5.5557818 + 1392 10.35447 -55.110235 -53.955179 336.80412 33218.561 5.6467392 + 1416 10.199061 -55.105641 -53.96792 337.36785 33218.561 5.7476527 + 1440 9.6868779 -55.087316 -54.00673 340.9166 33218.561 5.8432207 + 1464 10.093238 -55.049436 -53.92352 352.27563 33218.561 5.9471521 + 1488 9.7578808 -55.123935 -54.035429 329.93926 33218.561 6.0495014 + 1512 10.099979 -55.205426 -54.078758 309.26166 33218.561 6.1612976 + 1536 10.172944 -55.087106 -53.952299 342.93395 33218.561 6.2506202 + 1560 10.51771 -55.107635 -53.934369 340.1967 33218.561 6.3379856 + 1584 10.044994 -55.101362 -53.980828 339.03163 33218.561 6.4362567 + 1608 9.624758 -55.146246 -54.07259 324.32486 33218.561 6.5385845 + 1632 9.9135215 -55.097278 -53.99141 338.69162 33218.561 6.6452786 + 1656 9.863681 -55.070523 -53.970214 345.84608 33218.561 6.7518212 + 1680 10.138513 -55.127065 -53.996099 330.40757 33218.561 6.8775188 + 1704 10.382237 -55.070572 -53.912417 347.074 33218.561 7.0126448 + 1728 10.72487 -55.081147 -53.884771 345.83623 33218.561 7.1384216 + 1752 9.829431 -55.131041 -54.034553 328.57652 33218.561 7.2616419 + 1776 9.9135662 -55.100556 -53.994682 336.52238 33218.561 7.4193201 + 1800 10.41873 -55.097116 -53.934891 340.24798 33218.561 7.5570544 + 1824 10.151782 -55.03231 -53.899864 357.3654 33218.561 7.6872905 + 1848 10.42307 -55.043808 -53.881099 355.71677 33218.561 7.7933885 + 1872 10.276862 -55.085016 -53.938616 344.46273 33218.561 7.8887472 + 1896 9.7681373 -55.146507 -54.056857 324.84323 33218.561 7.9977923 + 1920 9.6624824 -55.103214 -54.025349 336.06397 33218.561 8.090235 + 1944 10.153504 -55.049175 -53.916536 352.36339 33218.561 8.1923703 + 1968 10.191954 -55.098741 -53.961813 338.8667 33218.561 8.3320906 + 1992 9.92167 -55.117079 -54.010302 332.96497 33218.561 8.4774437 + 2016 9.5737281 -55.091141 -54.023178 339.41837 33218.561 8.6149527 + 2040 10.600908 -55.092717 -53.91017 342.71852 33218.561 8.7639523 + 2064 9.9214513 -55.099904 -53.993151 337.46799 33218.561 8.898087 + 2088 9.9256258 -55.082224 -53.975005 342.85042 33218.561 9.0130784 + 2112 10.345379 -55.112923 -53.95888 335.81471 33218.561 9.1422766 + 2136 9.8876649 -55.079254 -53.97627 343.05764 33218.561 9.2885707 + 2160 10.04492 -55.074876 -53.95435 344.82419 33218.561 9.3876103 + 2184 10.028705 -55.063961 -53.945244 347.70549 33218.561 9.500967 + 2208 10.412572 -55.136316 -53.974778 329.8188 33218.561 9.5900362 + 2232 10.404205 -55.09913 -53.938525 339.77542 33218.561 9.7048353 + 2256 9.5694135 -55.139021 -54.071538 326.37473 33218.561 9.8045958 + 2280 10.244745 -55.134529 -53.991713 329.19392 33218.561 9.8968908 + 2304 9.9129922 -55.116192 -54.010382 333.14326 33218.561 9.9818651 + 2328 10.167027 -55.08241 -53.948263 343.08135 33218.561 10.068683 + 2352 10.262045 -55.144327 -53.999581 327.40876 33218.561 10.155937 + 2376 10.520934 -55.073147 -53.899521 347.6998 33218.561 10.246316 + 2400 9.9628692 -55.122001 -54.010628 331.25369 33218.561 10.336833 + 2424 10.565531 -55.157113 -53.978512 325.14897 33218.561 10.452039 + 2448 10.03709 -55.096409 -53.976756 338.29607 33218.561 10.537936 + 2472 9.384311 -55.141821 -54.094987 324.23247 33218.561 10.628689 + 2496 9.8019362 -55.105685 -54.012264 335.97239 33218.561 10.717287 + 2520 10.31114 -55.078831 -53.928608 345.42395 33218.561 10.818756 + 2544 10.407237 -55.148382 -53.987439 325.94421 33218.561 10.910801 + 2568 10.257967 -55.041348 -53.897056 355.73261 33218.561 11.004221 + 2592 9.8425807 -55.139428 -54.041474 328.28096 33218.561 11.101295 + 2616 10.140697 -55.100238 -53.969028 338.76319 33218.561 11.192211 + 2640 9.7102818 -55.136288 -54.053091 326.7053 33218.561 11.280277 + 2664 10.120372 -55.128779 -53.999836 330.71707 33218.561 11.369001 + 2688 10.232537 -55.120614 -53.979159 333.35087 33218.561 11.464652 + 2712 10.032526 -55.094761 -53.975618 339.97984 33218.561 11.559387 + 2736 9.8791 -55.121998 -54.01997 332.32556 33218.561 11.649679 + 2760 9.891483 -55.120919 -54.017509 331.32614 33218.561 11.742604 + 2784 10.201053 -55.165525 -54.027582 320.39272 33218.561 11.85274 + 2808 10.238648 -55.096449 -53.954312 340.06316 33218.561 11.939782 + 2832 9.8692851 -55.068632 -53.967699 346.77535 33218.561 12.036655 + 2856 10.179976 -55.128413 -53.992822 331.5662 33218.561 12.123227 + 2880 9.7656315 -55.1468 -54.057429 324.02612 33218.561 12.213117 + 2904 9.7991628 -55.049191 -53.95608 352.45738 33218.561 12.326761 + 2928 10.581767 -55.093293 -53.912881 341.37292 33218.561 12.417633 + 2952 10.546144 -55.07452 -53.898081 347.02025 33218.561 12.52701 + 2976 9.8306008 -55.14762 -54.051002 323.45715 33218.561 12.633522 + 3000 10.033532 -55.076433 -53.957178 345.36812 33218.561 12.72627 + 3024 10.046266 -55.085775 -53.965099 342.47786 33218.561 12.816242 + 3048 10.176777 -55.133013 -53.997778 329.04144 33218.561 12.903175 + 3072 9.9778064 -55.143787 -54.030748 326.75284 33218.561 13.014329 + 3096 10.516223 -55.110144 -53.937043 336.802 33218.561 13.104673 + 3120 9.6561157 -55.138699 -54.061544 325.6652 33218.561 13.207371 + 3144 10.237043 -55.060968 -53.91901 349.44011 33218.561 13.303442 + 3168 9.9704264 -55.123073 -54.010857 332.19725 33218.561 13.391877 + 3192 10.493307 -55.144402 -53.973858 327.15485 33218.561 13.482857 + 3216 10.022171 -55.141782 -54.023794 326.08249 33218.561 13.574484 + 3240 9.6957248 -55.137865 -54.056292 326.04858 33218.561 13.671408 + 3264 9.9685299 -55.124301 -54.012297 331.9015 33218.561 13.760186 + 3288 10.413707 -55.153604 -53.99194 324.32939 33218.561 13.877604 + 3312 10.022953 -55.103422 -53.985346 337.52066 33218.561 13.977562 + 3336 10.044478 -55.110297 -53.98982 334.48379 33218.561 14.065563 + 3360 9.8593734 -55.130623 -54.030795 327.71748 33218.561 14.15952 + 3384 9.9269422 -55.107979 -54.000613 335.18173 33218.561 14.258064 + 3408 10.288049 -55.092276 -53.944629 340.71484 33218.561 14.36211 + 3432 9.9702156 -55.08732 -53.975128 341.72171 33218.561 14.452123 + 3456 10.246178 -55.091669 -53.948692 341.62844 33218.561 14.555775 + 3480 10.559292 -55.086917 -53.909012 343.70626 33218.561 14.645718 + 3504 10.652207 -55.050897 -53.862628 354.46979 33218.561 14.797422 + 3528 9.9835266 -55.0557 -53.942023 350.74747 33218.561 14.895716 + 3552 10.240934 -55.123217 -53.980825 332.26434 33218.561 15.023796 + 3576 10.406519 -55.093536 -53.932674 341.54029 33218.561 15.203252 + 3600 10.406733 -55.095168 -53.934282 341.22192 33218.561 15.303986 + 3624 9.9877484 -55.154231 -54.040083 323.55633 33218.561 15.398883 + 3648 10.391829 -55.110208 -53.950984 337.09219 33218.561 15.49042 + 3672 10.368995 -55.069591 -53.912914 346.82649 33218.561 15.582259 + 3696 10.362939 -55.109012 -53.953011 337.32216 33218.561 15.679316 + 3720 10.465254 -55.136214 -53.968799 331.22288 33218.561 15.773303 + 3744 9.8238226 -55.10114 -54.005278 338.12616 33218.561 15.86905 + 3768 10.205504 -55.101263 -53.962824 339.04196 33218.561 15.960072 + 3792 9.9589987 -55.118883 -54.007942 332.84318 33218.561 16.047055 + 3816 10.253382 -55.117513 -53.973732 334.42101 33218.561 16.148412 + 3840 10.262393 -55.069549 -53.924764 349.084 33218.561 16.235391 + 3864 9.7367167 -55.078288 -53.992142 342.48207 33218.561 16.329112 + 3888 10.171202 -55.134701 -54.000088 329.5847 33218.561 16.415353 + 3912 10.01925 -55.145139 -54.027477 326.65074 33218.561 16.526334 + 3936 10.053638 -55.038151 -53.916653 355.74893 33218.561 16.618524 + 3960 10.044055 -55.058382 -53.937953 349.01834 33218.561 16.712577 + 3984 10.382422 -55.099216 -53.941041 339.28099 33218.561 16.79941 + 4008 9.97927 -55.09284 -53.979637 339.07225 33218.561 16.904198 + 4032 9.6782319 -55.126143 -54.046522 329.0201 33218.561 16.991454 + 4056 9.6593809 -55.123677 -54.046159 329.89833 33218.561 17.097172 + 4080 10.442896 -55.141149 -53.976229 327.9899 33218.561 17.189364 + 4104 9.9571109 -55.08588 -53.975149 341.3746 33218.561 17.294147 + 4128 10.44943 -55.087946 -53.922296 343.09435 33218.561 17.387357 + 4152 10.040581 -55.171939 -54.051897 317.85348 33218.561 17.500905 + 4176 10.089442 -55.128713 -54.00322 330.29121 33218.561 17.588891 + 4200 10.316156 -55.123219 -53.972436 333.59382 33218.561 17.679254 + 4224 10.177245 -55.095671 -53.960384 339.34498 33218.561 17.770569 + 4248 9.7129183 -55.135335 -54.051844 328.25125 33218.561 17.857728 + 4272 10.231838 -55.099554 -53.958177 339.64015 33218.561 17.944226 + 4296 9.9737677 -55.117885 -54.005297 333.07248 33218.561 18.034105 + 4320 10.004955 -55.116155 -54.000088 333.52271 33218.561 18.129644 + 4344 9.5938901 -55.133824 -54.063612 327.84171 33218.561 18.215476 + 4368 9.8954562 -55.131603 -54.02775 329.0813 33218.561 18.306539 + 4392 10.439732 -55.100379 -53.935812 339.81679 33218.561 18.395651 + 4416 9.934513 -55.08449 -53.97628 341.74441 33218.561 18.484506 + 4440 10.025998 -55.136771 -54.018356 327.73718 33218.561 18.593946 + 4464 9.9304451 -55.101817 -53.994061 338.1801 33218.561 18.684011 + 4488 10.344371 -55.085856 -53.931926 342.91721 33218.561 18.782399 + 4512 10.033193 -55.091778 -53.972561 339.85728 33218.561 18.879666 + 4536 9.2361614 -55.169375 -54.139067 316.67597 33218.561 18.983667 + 4560 9.5786289 -55.179976 -54.111465 314.76415 33218.561 19.079009 + 4584 10.071651 -55.107218 -53.98371 336.10364 33218.561 19.163975 + 4608 9.9873098 -55.109348 -53.995249 336.03665 33218.561 19.25635 + 4632 10.143888 -55.119423 -53.987857 333.74978 33218.561 19.346658 + 4656 9.7506264 -55.114772 -54.027075 332.98271 33218.561 19.435425 + 4680 9.9616769 -55.096054 -53.984814 339.20499 33218.561 19.55562 + 4704 10.271313 -55.074522 -53.928742 345.87397 33218.561 19.642652 + 4728 9.9172336 -55.098805 -53.992523 338.06318 33218.561 19.734557 + 4752 9.9556222 -55.12128 -54.010716 332.66408 33218.561 19.83859 + 4776 10.197593 -55.095293 -53.957736 339.50067 33218.561 19.947471 + 4800 10.145085 -55.108467 -53.976768 336.05115 33218.561 20.044183 + 4824 10.205523 -55.147376 -54.008934 325.56559 33218.561 20.144393 + 4848 9.8900281 -55.121598 -54.01835 331.17401 33218.561 20.243197 + 4872 10.03655 -55.100936 -53.981343 337.6777 33218.561 20.336043 + 4896 9.8120635 -55.087507 -53.992957 341.42438 33218.561 20.425498 + 4920 10.615354 -55.093335 -53.909176 342.30776 33218.561 20.519318 + 4944 10.374366 -55.06455 -53.907274 351.10607 33218.561 20.612312 + 4968 10.677474 -55.147807 -53.956718 327.85703 33218.561 20.719371 + 4992 10.558882 -55.145253 -53.967393 327.427 33218.561 20.818726 + 5016 9.4097946 -55.150835 -54.101158 321.62641 33218.561 20.914472 diff --git a/examples/gjf/trajectory.0.dcd b/examples/gjf/trajectory.0.dcd new file mode 100644 index 0000000000000000000000000000000000000000..47927e9909cfcfc86ceb2568ba1660efed5834f2 GIT binary patch literal 439092 zcmeEubx>P-)a?m%rApmsu_RbsfbNyL3nZbgw72dqgu2rf66!*Wph-<^4HzCT{SnRe#fz`5b@<0pHsz1G?Z5d@)KufFZ2{QB$P>mq{S zx$A#^`5*ohne`=5@*nR0#~ao8RtR5v`Eue*J$20V>0uM=51&)NJ9_l!9nAOsEC2d- z=z+f7g6p@N8a8Zt*vR_+t?GB3F@BD`u^)dmY(-ooB;CH&xri%ET zuA4oq_?@ow=`!BWzt1%zO2F@Q-Rz;__4<9T8bx*Zovt>IO!%FyvFSGaPS@{rwtkJ} zcRE|Y#_~IztzTpLozB*;vHVVF>(^L*r?d5IEWZyj{Cgz76E^%cmfr~*{u;~ggbja< z<#)n{zsB-AVZ&cz`Bj7cy8bPX{aZfyx48aq@%7*0+`q+}KjZlucm0{4zwz*Y|NZly z^9uhKzyB?c{#!izx406a6%_y3^>2CX&v^cxuRrtiH;?h3?VVrue!uzo&pD1i`Rng` z`AwmAq{^8C3;fH?J0RM1%|8Q9Ua5aDK z|IJzbnTJ2~@aMez&A0!Vhd=Z1|1Tc?%}M{mz5bJf|KY0t-2XE_|L_O@=mr1q;(zY{ ztq=T}hd=Z1CrXpm(Y^Am!1@=C8=JhlmhR%a#ke$om+@u8W5&4T8^#Y` zoijr9a{~siOAZXaC=2*xhzXqXBRk#p$|e0-?qXx>Dl?56{Er64F4+~BwoYq&xMO{w z-?^fJx+UR(`$BvIr>{>Ae7df6z_=CF(^p>$HokaVGH}(bqv>1RPa2~ZA5ZTX*|<%& zw+Y6ge!Bvve|i-7zar8sq2G8`u^Xug3{n85=5-DollSAt##j;B>3>qcJ`&LpsnJ>fDZBm>Llp!UVy_6lL_&8jO zOD*M)?2;kOKLVMEz@2~yTzjR##UdJvpRB=kYmM&@~kE2TVQBvfvnJiz78t}b+cl!s};M{RtS@=2>)(@ z`Mw2Dy72oV`E`i}m#$mk+0KH`v#nU9v|_8t0!MQzKJ3ZH#urvZTP<)sW5v#4R$PB( zL9tH0)X*-cjVpZU&~Z;{V09(0=1s`?jwhA)+K_%u^`^v{Ze$$jP8~+esq;Z8#gF%< zBQCy_(a?*2UTaQaUd^fTTwf|$LQdU}HK6IwdRlm}Z{6D+V z?j16!e_Bpube_~_mIpQN=tdJ}xYGP8a+)#Pk8-mMsdGC4g{=#zl#_t0>xDF`xddwucTlxd2PM~+VEy?} z+`rrpYnS!I&^jSVa8g0nUX8o0RTwc*3F~t;BBrX)y@nD!SB2nuloB=Ph9ES~; zimy>YdQ^q4$3l@cQw>+O3Om;X<3)f9p@k}hPg0@xLN#8VP@;=G1T{;kvAKj2i&m>) z<>&7AP~kxN5EQMa!u*#iOzN-2fnz!}?HL2@LmfsO*J5rj9hxU;vFU&gmlZlRiq_#% z10Cj;(jl?54(9^3i1XFLRU3_%3R)cY(V_8kEo?P)XfacV_K{jVpQA;sfm$q|sfFLK z=QPn_$zd%@6>2f8l@3z=9iQ&$kbF~z{RKLd=o^EeTrG~4FvGFjgarposI}XSEsxDO z^3#L^uT3ztF`?X66TVh4A^cq?R8vi;KGTf1rOjx2)`VkS&4^l(iD&0BK_ktm`6v@b z@0c*Aml*~Z6NC!)2%)O$;_%cw|Gp+IFPP%7JNt4Ks_` z(QByooK_hoE*3{vq9x-$6u4|c-h>JaxpfNBS2qDg4;8GlI@xV z?t=u3kC31QpPNs$1(eS#q$xoH+-?fE(b+*MLLm)XQb?uS7Sh@1-|R09?ItWaV=MS!OR1U$7}H%1q_&wOZuA(ZO|`4xdkG z(e{BBg%$YcqqTUmUk9(TI?R}%#oj?$M4r~-r(O%y2_0fP#UQL=48D5n;9}I`VJbgY zn}y!dCXDN3hIXeJ>lT`Dkk8!K875pYW}?keGae^o;qnPSLoZDb4w+DIxCxWyn31*A zghp}vvzeJZPbTDEG$H%32@9v05MwgIZ?g&G`MjO3YR1*=CKP-#!DW&e&)S-?rg9d} z$;=!}%xF>Bj8wG=8#N}pt6;;vB{mdpx1o7k8>*DEq1*>EYz4n4mf8g9c}y$v@UIS6lJ zgTBy)obfg^`Iv(x={776%99&9|++B?19+AyQa`IfQd)pEw^ zD}MykKD8#`_4(QXVV(m5;&+ZUmP-f=+&k;@iT97+rN3+RDLt()<;2s0D+A-d8v{2M z>ze+odX$`KXH~Lm3ANN+whG@yZKpt7k+G`m$2J-nVs&5P;DxZgmdoDylt z?L=C1Gm&$iNJXyb>GkY1YHv)Y1G;1yo^GJ^u8EYSHBkBaNfdc1nfhJR(|UOlZ7wcS z&>cP9SeHzZIzmbBYBRsETwdCS|O6pnq=y|IGJ*T4HSG? zibFqSc-}{bB3r%SS4#^03ON?+_r@NH96!IxaBiFo@88H!r7Qalo67OIryR@r%iujm z3Xd6HxLrYppsF(1S9!s8ycA_i%3$>OM&qk8ge>wzpIb7_GDzWCSBk@sggRwA}Aeyhd!F0_~dy`M1#93*1!C_NlyL>zv`IFg_B@-Smb zlOEJvMCw`*9W)|JToSRGzdp*iFp-~On9jJ<*MNm<40yIpM5loU^y1&wzm^D9pam|= zEht&aigPovQ6t!jF}tl;UEhLXdACq!niYYSt;j#cSg@xB1DjY;ow20xwiRWZtVmsK z#hxe&&iY!hILv~h@fJ+DVSyk2zc>8e3qP$GcisXF%frYE^WwfcOH&se^&^^XhTSgR+Uke9` z!4ArD7LdZ;@GbAvDCMU{SQ{1IWQV}1w-VWBwWyk=#T1Jc5sWibjkVY|Fb1t_n9-zx z2}X?>@`6k(Ich@Hsb)0bIB*&^)Gn}LK^+_RF6S7K%V*zHN_ZzD*SY>QQ^)!7rZ>Hf zlv0hF1vFw#0X^IzU~E7k>5~N1>mWgtnd5u~HTI2DLH&*M%;gYt@KR&+869Gd=org$ z9M052J6ns`k~%D(WyaL`CS2WQf-J^_E8-4NoNlQWm%zrPz=+zQD@^DaH#;QAg`{B)JC05=J zL1o5~_8w}8ob&4SkKvr8L%E(h%x3JBR8@yl={ls|HsL*wq46LyigTQw*xif^pG+t{ z!HyanV@t2%I2mNaF2*&Ub8Kkz)Qvi~_oU4AGTNQwLt|$7(&|o4=mq27LG2}&A{S83 zPy}=@{<;oCfSR^f|>8mhKxBwN4J)pX4BE zr457L%4qfyciPykDQ#`slsZ3hBUu?A8g7+fd0k$w0Y#7zEWyC@PIx1A;u=r|d6y8p zAFsr)bTx)IQ(^D{HT*e$uRj}&p3gYvkJqAE865_3{x8>>=V!19yRMo*3KLAvP3Uhl z;REB--4An+=4XTAnhom295lPfzWik(-SRY$=4%Qa_fMk0N_uKh#z5{)9D8?oVLr#= z`PJp9+FFY0XQimnm%Z4>G`PMu97A$7_&QjFJ)<;m_7u@=j~-9Y=ppN>hxomMn&WJR+`D_Y8}comq9xZ#4rHbqcWlt~mXCkl$#k`jgI89{NeOcH&+sHfOr zDWpkGpz^y!GOLm({;m{0O}*gJObSS)xYtXD_=9phB>ubLGbs#+oPxV~Ms;L9zpgEv~y?w+6+-$PLJ_$ep` z$R&z1vjxTe6hX18auPMXmq^ZgQz&q3DoyKUpo=f`w7I+tBWKAmH(CZ8&sF?68Agp} zKEx{mpEER=+L-f1)d)oY2*=GG5pYY@BQ-$861@S_jd}z-889#?8PnHVF^OyMvXipm zQXw1F`ekEG2P-l~K`|&*P@LmAn*B{s7&-}x>URW1dELgqPo zda3k=?Vb!-52bK=zr!Mli-4JVmc^gL z;jvnSTAWwAAJt%POBh-R(d#yN=#J{`1fi1jNyQ2j~mQ_$ZYb_|AY?M-k{vLFEvy@tN zbEirHo-{F3N_DsfscvxmYP3d0u3xPCxaP65-sz`Aoi-uZd{~W2AC*Xdri9Kr6s1zM z8233ECpcF`*3)4!*U75SIvnEqvjSuE<;zUi!1-&x#0<9;X54#YL(%zm7zf)?cc%^2 zAKEY>g6qkZKJ;OQCymT$N@dn~)1;~%lyXB(Z9)oZ#=b(DKdg{!oGT9W6wq*<1VU34 zTs=cjuqFgyJf7wWYLp+X#@1mvv|Oact@~OuPt;*;dmZl9)nQaEGbYHhuxxrJsx!t9 z|6qo2g)#nZ8>aI(#&@wp%(ub+tqu7FHmq`Ur&0BNsmX&T^w+_rw4_i*&j&Rm=VB5Z zt}KB$$wA(nQ$JR5P>oGLX(PvCLwOZmomPUbD`D%UMhQtMrcKtN%v~KKIiC*C(qb0J z>zkEhkmb)jKtD6iyJlfndoxT$*zp3K$k<2tpK6CPx#P`;5GQs!GyGgTP%NQH_j z6=H{IQP!E~$c=OQel6a%)1iZJ40E9-Y;w=Sz1Jq}m-0HbG-JSh6Gn3_lmC_TC+GFc zoJ;48wPQh`9pN7v(qBRT^mw%|Y2Ub!S9^cjztfvaxp7|K>V$Dx2~Ho9pgz~q-I@uw z_gw|g`AQ`9<9T_k!m9ad%$&^iXOI>Zm{*y>S6i+J144AD)JKP}%%2=AYewH!nb>sC zgeqL~EjVIA7U!#4)wvGZU_;AV%v1O?{^9Q%>*Z8=tS?E<`_Y>VGCDp|PPx70l$apF zh&DwaOXAvI?SxBlMbLT^*V%a?cziGzUoWXpwyGKd^O(EZq(oj79e#2?eKw2d<$N@5 z9pJijlolt~WMUkTq4Taxp5kVv(gNpH>M%)9rL{8L8X`sCI^HO&mm-tvjY^-q5G^qFo)V4`jU#a05sv0x zHF&i?0uck4V@+dB%yIGg+ay>^8sHowq9$YCCUvbCFvNnC0t*uAGhY2@!CQl%n7Tqx zTrvrYv;KnO`X)g!ier*yTmrS*BvS0qM4InsAblSLedHSJ$8ISC;=FL`iWEN=b1l<@ zIqRu%eB)T$YP|-z91H!F8pw?rG&rHb>v5b%n}~?K#u$E}i2k`EauY=KZkCOk9#+h$ zlMR1!gLf<#E=UxwKL`prkE3avpy<9*P(0ruD4H!#qAiz`Y16h;a&MPH3pOND zkTchcDlb$Ik>mCmFMLRm!}XgCj$k=9; z&U`zMNf;Y}fIK}iq6|3nUc|v@JuD^>ZAiq8^;XPlm5nfWD`p}a3olu4ylpnRa*lX0 zSy22u!E2N*C@wq_6z_QrzdT5xr!5RLym>NR*)P%u_e8o;-#`lsvc4XEW~Me93O zsE1n6lrd0zCo7IK?s&98P{b_YaXb|iR~Y{k%j5mTxphXqNVd2X8t9Qs*+)eRu9iy6 zqeLn_P>MO*Wmv>mV|G7ptT--1g{eMJ9M|C3t%az~`&wBd9M1=9@HSF|9dD8l+k*GA zj~?fEZZbKyFYLp)_1i6k@Z5Avfvqcr;CW08>a{YV zq?-*m=0iQtNpNYq8Yi#oaPXT6Kl<2k(M3+FOPMb}7J{cjWOrS7FGbXk;;_-dMs8*EKS_9Oi@(ZfXR-(Ly|H#*Hy{)Qk0`!9yfiwLcg` zuWB(=W5Tq{oO_L~w7YU4xx8T>akUnSW6aF!b6uGurwLCSRFwI|qD6Js!|(4kI0ue! zKYBRd39UWVn0!HtO4m#{Q`U|IVFvOQ`x0K*pwi0^I zeTAcWe&*RR)n86yo;cx9t`bAmYf-v{2{kx=N9B0123SamZIo!wIr9#4dOarQARx?@ z7R3Ift`k&f8>&TzluW!}?yF4`DLu<`(1LMFjF9UvI@N^qQa1D`*@#ZH65#wqiNGT~ zZ;ee*)wkj4Vkt?SB?!H$f=gd5c3sIt+gEapvq1>Z^Wn6U%bbILcFcv#bp{P&Hh zjrfydoz-Z;CH(Z1~W&Astmq@Ogm>x9Y|~w=4@e$GLvXa;5y!4l<2ZV_j$FSDnpx z$uvUhCAo9;m_YaR6cuMnJSrbF#btdFeZ+Hg*N`o+<13m;}53kFrs%CUxEO*`6i=t2R{JVr=*IUM^i%sas zwQnb7BidY1f}TTEaChS0+dC88m)o$Sg*W9^74W#G3O#>BBP>1>uOj)J#`;mkC#*5> zd2iU0apmMp9C(|9$}1T+*K<&UZwS(OeLaIsI6TjW;!WMiBf>#4=A4LeU*%IKL@8}J z9@Bs-%N;a)w-S~b96uYG5LCyG_$M;@YpQ^YrPUac5RDHmCM5BG(*=1_r633CE~_w} z*U_vqA#F2r*1f!GMK1vzSU;%7^Ru~rCW4v!IPKv^LiYly;;X{;8Zmf(oN-)t){VM& zQQSxYJFIFvHEZF-T>OB>{C<@uZC)kdD?g_m^ZskwG1i*Tm~T@Ps<@H0$wg{BzQ+8E znYoQ+{P)iHAn}-k4%H6Dq`^8|FVA`#YfiT-x>IIT)?*@7=)mzI*~bLeNjALqkWp`c z2`U7uG5fL(o;OWsKaRQjK_2wpA>dj|HST}bVoQJ-b*I^J@n|E8$rtebg9;6%>9D%E z8J8;C;1uOW?k-N)^Enu2Pw7}|&P4P1HVm)oL&M%M2NwWzE(Pre#%Rz}|UNpG8 z6DEOqK>m9bWlh+;#D-bJlIVUvDXO&4U|~DPRm?eFm@X(JUlVD6TQBq-!1Zyk9tT{l zNZBVS!p`X_aIGimc8|dIED@8RS&+z>YTt<@YSPpjuTE$Xvx;lf##W5Y78DjSg(~&t zdYgIP2A&3tQ)eTqi=g;k$w0B`-Vg_AaCZ@NB(iJ-_Z1Z9$0gJE<6cR;14q6mDx1=+z!i$R3BozDdNpZWaWLWsV?IB(Jw# zxOXWWPgaXK!kF-)Mo`>+ucx~r^W=>*cr;CfUSfqjR!|I=rqcI4jE$M&F7Rhe$DHqY z{(GOcOQtW7!@%|U66SD(4;H-NEhwVzi=-C4kaj2>$38F)9b-kE5J90kqNias<>)w5 zgRDqBG&a`$8w-k4PRVrUvJ4c@n06NP$_*@7%v{E)+KE)^xfJ{V(!kn-@!BE_z*tpX zN>9-|Z?#)%P{WvnIgF3azY!G6w&9BU#pF#KR1q&M^M^96-@mYxR9m0}U&-sN-j_{P8Y zR98VEP7=vC#2e<1;V}0RF@1s+O|A-x6GaX5&cQhGp$6ABifF)i{E@$)7*RQ%Qe|>< zn;n6xLqxd5G7dEhilkA=^u|?&vk4mPZZ6_(t_4@O3JOmcsJ^olA*aJJll>{h7h0iv zA}F*iQfTHiITkL}z?d)MyVZi$%-cydX85y9G}C97p>k+WOfGIebpH-qGXbCo5JmkF~g?ft;SnaD_Cux>}EL?`&NE$b8^> z109fhV{t|}igOKCvJ2}Te+dfvz+`GxC`H3W4U$i=CbOS?FU=*2!Ab*7<61^}K!d_r zdc;3qZfG#i&j&qq@|9wfgx7Zh$ANOJo9uPq(c45iv{!})-8GoRf7gjhR&37{6y^IF z=oHsMpIJMSeiso?J{z~^alGnmpwqG5P@fD(!v?(WT#p_ZEK$IaLYov`%oi-gD!U$a zCt5KyNTOKuIGHv^d0|W**O$liD4$_L^mswh@)&c6UFE1aUjv0R^MB`Vq0bOO@hwVE zzVEzn>G?t=*A&rWo)yj?9jG}kiFPlQA^VaBk3B_H$+Mt11jVC^i8Qc<3|)t7@I$S~ zj9wO;Ud?s!W03}~^@6`O91%72khizsS|veIN@1XSC48_$9f36$li+aT`fRPBsPH<0 z6wf>naaDtLkJ-nRmW|#=ne!YFPf<5yc*JpLcx@3im~*>RPEd5-&-=5M3?IH|(4FhQ zp6M2BE5B5)#B&ov!$!pVXnHztwfeWX}>mdC^AT06&za*G7TD=~qVAM!@SKn*JL{-1x@ zio<;b#bQP6qqTWwIA@Dp@KPKbc%JFlCh)2%ZXw2*NU-dJlA3d4gq1buj)yNTn^FsyW z;i>!Ew5~QaaQ36>K|{+f2$-Lpi6qo9 zP-ou5jsT9c3uMquWbdL?j)N)Qu)dWds*MbJd~d>R&QpD**t}SVz$r4EIK**Z!5kCo zBXKvScx02I`g|E`ob@ag(1}v6~bR z&&wdaD1+&k9OwD_-dp7edJv9q-UD-XuqUxq1d_wp)99l?_Bi%6#%WO1s=YatXuo(_+IyLtQ)IAAU|hA z`3O|)7J-<${G7CfSkqO56MP11TnNW1_Dp8*{*SrHnh$Fh3;3KJKgu!lnFw`H_BX!J zBdnjEIb0DDr45jc(Btk5JsQUH{%5}Y8G9b@))2Ay6X*NmBANwo9{HLCmzS(tGsl0j zI&0P8dd#23-o-=_o5%8d`!j!Xm7iaef7fU|+-%HU7(_hTF2doiN9PNyF?kr^y5EAa z35?bF9JkoXJp3Eh1qNF&coOFej#*}BD^9?Q2ahc1r{dhT-h!3GvZ3eqFWJG`_DKtB z-?iZGCkqA}Ecja7ib9U18_X7r^R(c>1PksLvKGCOwP}tR1DtS>e%# zaS-!4XPMvWIm3$0vl>xkHFrAU;!jBhQhHn6ovIG;AZafjO3rISWk-5a`EhbeW*nW) ze#h1|Wt3K#Ie;Htw6>L;Dn>V^8v|wJpC_Y$u1zR-yp*L5{&~xalM@y#b<_Ke>oKfo>1d<8Lq`< zg<|F%CGI>9L19xBW+_#eX;5KB0rSbCMp8a2Jx6LpBa06TQ3wnv8zd@V1~VtQ?^d8X@NSs#N< zo0(79t%cO2MZ-xtjI5x;iCtQ(tgeN#zZNt>i!RLbPw%Y*`skp4AICn+d3u|O1@|Zh&&h@uT1@3%7muVO@JF~AyZB0I){0&VrD#*n~=}7R_-R&u1~W+E7ydl zmCX3OnmHSP8}>)r(6gEiy1q8{gykSEn>matcC;U8L)-o~Tpw#gs<#~{zvSReGp;MI zu@1k~2In9fiul-YIFM`5LpC_9HhA4)52MzGIj3@PvXKp6OERCfmbLoBcBIN}T*Krb zurLSNk8-f@9KZiW4#x`iHny|Fy3Lb57IUS71MJ;pA8@GwUUaaWj6TH3sn{uRQdIG! zI>)@IVMBj zRbQIF(1%`R%BUXmCqE~6({elWSoOSU|7Tx{8_nEadskZCPDbwA+1s#GPG58m>dySd z>z)$y-sFVCkpjwcy}OkCio-o5=zPvWBhNc%%oz4Ke3D?)6bZ(g1YG_sAdU64ydDDc zvI3?bl)%V*R@W!&F_sA^w#Nyh>Nseunf;E99hBxQLG!2rYF$Nw*@K;!1LpTUmLTD# zfMGui>DUwp-DoVpzL`A%%q_fI#-7E|N-VjiLX)>4=)-5FyIqOrBh(0Ouf`}Z6`nOy z!#-Apvw9WudsNuXe#YR%O4PllL~3$Bls%wAdK>0#OREr<6N2LfN{lP1MArQf6dT0n z=U6a^HJnR(l;}`IjXCZ3=L`Alo#wOoF$A5Lsc&U$jbUCgJrkw)`!`QaSazBHFJa7iCh$30 zZGs}hgrYUfILkV#W-ogzx|wj2pSNP72>}n7Gp)&fqVN232TV9JG7~qL*FEIIoN`4o zdQW1ljnDUf*0{Fla!_=R9bJy(pvD9nx-POIG|z@Uxi+-EYeV;aIhfzfj%mwtFl|5k zgAdv9I>UyIeD4~cxg9(BTwbzagxUsavK`K~+2_c7o>ppu#n*;nzIH6?WP{HG_Mi0R zGpDm*c2PST@VRZpuidZPU^FrhdY`$(mUisxvBsD-;iWNlk0j&Gmz!<&)N~JQv@tp` zZ;2+ba@kdZXOcWKT5PFkEZt&rz^%~Y#@w)*>Fu`d2=ot5H&zZv4(#78FL2bD2xEWW zJAv`a8i6B1o*JWS>`uQ@w~Mj+>7Ie9&9?<+M7jo6tk%cqbhfoocXW=i%&sMY&+c_P zacXx#o34%D8~cS8Zk-~W)YcuWTNWU$|%0L-P=6YdB4R0J> zBS+s!QnX|Ic$M`)|2LjUjF#e6QyHGUlVR&1DY{0=klUF3izB57@9c#(wb^GPN-_SW z4CCiAMr|v@nq-Or4a7w|tPXi4?!!^iX5`hl8HTXDQgBe`k=^k(& z%pMIoT+m=K%gm)SYOJF^2xdwXX6mGTFBc!*8jYC9SV84yDsR*CRB34Zi z5p!FQEmK8&J;5GDFaDfw_9J>T-aFjM00m>nr}y<(b5)P=Jz2{eZNPy_?0aPY&_X{E z?U{SHa3=|E-Wag2Bl9=!^r*5t3E|9{GzV;TGm3tjN2_JuJl-BhI!!%e>6)6;|{Z!#Iw(Kc$ToSJeFd39fH9 zSn+VR$P8|3(f9WaKI%S zjV@WSaI6(^Tnqm5xge{Sd(w_}a_Y6nkG>~KN%-PLFKhVFwfYiNyi-62ck`={1Px{t z#e_!!G|CX9aIF4tk$F*>8nKgE&ktctq-DR}BQ2^B`vzZY;cMeKcZK;;j!DLTW+b!z zaiKkX2-%Z1vmW<79OloDx@kvg3-=W)vZJf(TMS_RWny1fTI=Uc8_Rpspx2z&)KXgf zMou~1zSF54tdETPNw?XTFHI_-{6kKtVW` z!`;P)F7ezPpCl)1o;O`)%v(Rqm)t%Tke)sMGRBqeYYXY|O75fiAfR>!_7jAKV%S$D zj+RrRVGAX~t|@UbOot;cbr3?dSoedya`8HJe!^d~=i-+yZh(&&or{{ee}v~M+l&uS zIX;f&-U){d>v}UEz1fDOnXKQjZ*W0eHa(n^EpdS>Y5%j_K`33-YBCJ zPa4oPiJU?%2r!H(pzbdP%x3K0LsdwNc~7E+1xc09pcq!yet$suUMN1 z)uBl>9oBI!&b-an8^*dNO}NOKku&G4PLXCbUuH(DLuL$iZ^wUZrB zy0Xtc%7@$!%IVuSe>$;?eXy&&skPmmicI7_s?$ygU&j3yj9H=<^Y|t^=s}hey_>L> zIFNP539L!nRbh%s4gK+GJgcPxF(xQHqeF^b3x6Z`5N&1sB;SmVBTcwj-h|h;&4`(A zLO;sEraC$3!J6{0%pA1c%l?p1_JoW#(CPADBR0Q6x-MX@mZQg{>}6hzb=L5 z>`A7wvQ#p&KYsRRPxOkDq2mSi7OdlV-araJ^2VDN9JlvGV0;Y?pDzu2fi>8l#vJ&5 z?hlk0Q1P{h&Ri3FpD|!2^GV$bve7Mt{ny=@uUu)x)d^O}dN6kuD=2z)6BI+23JU+) z5=HM8f})9?_5INXqRdn}(;%7JbDn!RJC$%fnf4gHpdT;AxWn9g87IY&P#K(S$l;e6 zfzfj~M;z1O@@5V8E{VXH^~?`^6=Ap~q7Do=7sdQ)on+*2oxU!TJ>#hyD~EHxV1Fy# zdfmo~hPTn&!Ja|(>xC5viiNBzTp7dTVt#wZoCG@hYkoXas8eJ-ZQZM@(?sZ=>e0ZJ zb5W`R!|!v9ceY}>*@{YQt#Ie~U%xT0*9<|CJ&<{2=D-gXlPJpaTBY;4-Q1W$*GeUm zY^O+j&WfZ}BvXDHJ*9n4;vU_MCJ`G3hv#e%mf0rMv-Y51Idr+^UupM)!i5F@J5ji z;mFtX9%divLH0N;%wU~C7lHS+4d|*cp!5j#$von9;{1F2frudH=}U5+E4GJyDt$Ot z^4|Gc$XsVz)@-`)e&IcByvAOlg@U5-EkRLZvtzU)ol8tig5_i}FF8f~Ej{kXm=zkz!kD{y_|8478p5*eeo z_v$=*E}ybzBaQ3+lUnTI`l0R@_NK+@@Tf=@N)#}jk72*XB(Bd(vhQ4BMsy)-$VU+-jN37j|vZr;tgYZ-eR z`wG}}f%`d`2l>)ciLIs7*j7!6Qo%|DNOXAKh2!91EhhZ(#ZA^>_+A~RjbXoFu`EQk zGGkhQGj@D2BXAbyvQ>8Y9nHbP{W;ipg7c{VTe#|MsO08FwOaU4{7z3QXyQR5GyJH{ zZaIzGUPu)ybHA#O6Rw8~2+#@e<2o|cQ;F4#F%o*JF?cKUGdxEIhY~-Iu?Hhc3(E>E z=6&OujB{$!mt3FCV|}%$89h_E&RN2Igr6DZ7H~eDY(v!m&RdaOr_|%Tm10L+T^lq{ z{b}M@A8I&NPHQ%JQ;n-$q-xi^80T9%Sg-J%kxJ)KaN$Fuah zfVp|xTf+0zC0GTIiJZSUcloH8gSr|Dr|)XS^kS}OmlmV#TD-o+K75{^)}>+)9?SlP z;U-usm|^|IHKLapho3Vpi{L)AYrH;rHi(RYYBN4N!~BVDxcPHtmC-jrpHLD z9&}GkQ@g*S@#lIV|Q@f zu!wu+%SPbmBMsWJcKqY12n%z%%acSr9-WMhXSw%@^XG>S+34c1z|_@>rPUcPKjNIq zvG~Cw_Q+M2D31QpT{tc_f5|a%QzDgRjm>&6nJS!2qmXp|+=F-n6)7vlf?jgeZNeOW zJ1HV6%8{2Qg^}}n{ZRH*_KZN@!Emg9wh+b?u5(yh^a*A^_Z&SYT{j?qqX82yh}h|! z%|2c3YvTM>(uwD4DElkz*=WsqtJwn9yJoZYbWl*d<-Adzb-;IAM|Mm$(BSw)s@FP^ zKD|mNduKg0$mSYu1NQ{f<9@d4-dNU4hD4heK3CGf?#BK>Gy4q&u$ERBj*sPd&V1N2 zkjMJaDiNjjvflmF02O18+a;~&)RF6m%2upTWR29uz57zm@lOTCj+267I%}Y>PVriC zzE5i=Cmt?y{j@LwP9aCmK?ICtaGG?V;|Rk zA1-S!+!}$vXbogh5$Lj;`_7odPviP+MMDuE=NOQ!Y_*{5 zR_^KNxk1GVk%GB*VRLsGYhm6f zJyQl>55^mBWVpLrhN!XOSmdHX5bxvp>-e)6ShvjUslmH5to2Xjo(`U$!=Jd0OyO~{ z4$!zebMKr(!v`jRC`ddf)Rg1M4?M|>Z!Rbvp# zJW!<=R#ULFc^`IIo{vTgx;ThNnP2`(t&#fDk*WJ9($xe zWgwL~(KoML$*;VCipx=;KBe*5+za_dNHt8*N+<`%vw4 z0pi3^oSecv`3=o*-Dk(KvhL)PDWD(waY}n~F5a4nu)#Ul5hkUlMhBf*)EC?5N2AJm zj$LzeptX5WmCp`}e6ED^yJ$F4GvSh!gYv~>^pmxNj6O>EFV~`RYtENvYzPTzOlc|s zb=ZG&vXl-9?C(>&3D#w5%qGk8EH=!vNu?X+{NtwdThdt3pR8Kai_@QPRPH=TxV4tKl{agcH{aw)`t!r{z0A# z)QCHy#TBmWuB^zxy(BqZdGV93$FdKOYny!*6B;o0)-T7KdQLB(#kZ7bbu${X&v38x zt{l9W*pRx;WeumJ8e=!>u#fBcPbGPrBm602qrg4QTvsxm`ieD!Z3nnEoYH`Ly~(Gq zFO_(~IeG%ul26Lpu=sK#GWHcP^okOfhiOr>r3p*-Ft1)wMrEuHDi#~cHMtfeyK)|X zk%PYRo^;T;kb4P3u(zlVo12?3q@NAdp46ks#~DYp4nf`q{w#~Zj`Snpz;es;Jud57oVeb zn{x1Vl$5#-{Z35^g3+NF_qx2!#CFyS${PJ?ty}_$TL>mH|ND6q*T{Cxo4@>G2?B%# zO0053qtScz7nir=9ryZ0bt$A)KL=!hfEG$6KDx6;6Pt;NTx)M>A*WMK1aul7f{)eNH@7wu$?i4`jr62}asi3V zHH<96_Zbtu>0^U?XICnWaDv|tHTvnaC^E!^vrlvQGiJQ#Qau5_H9`<`Rg0AFnON~4 z2iMknQ{=}&iX5WE?Fl-ZY-&PbSw8QjJ*a9g)&+Vg(Xq7-)vf&ZhH&3H`!rh)WxnGY z_eYM^Vfzsi7H_a2rJN6Koy(d-Llu5LV?QSQY6p+7qhpMmy7Ffo6l<@NXgAmNbQy=A??GxGhCk2$Yk>nSIA?d45D491XGXz_@7hlq3=W*w7~>Y0FvUAQl_ zvTNPFwQruR2|e8cYULZ!BmcA@t*y8{N;eZ+1(dK8A; z$*^02ZG_!}&F*Aicd}W>MquCTyuXjnm5o(h;=Mi;Wd`#6)LK!9?@Oz}9?~;HfdU9cPoCQ?&!rGm^8r-2`EV|poT2V!xgFDW3atn6f$=UiB6~)|cbplES#x}0->&zkr|u8Yg#|@R2pw%s_>wYtXoT3}&`rjhaYp1Z%y8)Je4|p+?a^(b#>T`2#oUtKF>7 z-g73)zOnRNnWZC5Yu(!&7>Eo}#g~EKE4(v(R+i@YDy1Z%$(xapg#`FC; z+|i7&{Q3v0E3`M?@0Hm}8oVtZ4eK-$zWGw0p;l-&k28weR}EV}F`%y0>rt2CzKxiY z+AOC=_@Ec-NYCfY)@n@e=mM_ine^10R$;-EXebL2BbsAJT0QDO1B~+iCN()nqwui} zIfzB9A6eu7vo~J0UR9%rEgH)QnUK&s16$9#(4c6dB(SCrkJe*jwh@us7m1!OoX?Jz zhFw(H%lEz395al3&X!lG&pnnT<43D-h3nHjJP9*Lk_%|apLc*!e)Lx3_6}xF5U={T zDf1AB0d+r4ozp$$q)p^L+Q+Z|PbU86dY&@dB>#3)L0wyq3f#YWhskH~eNTOoAPXzf zQ$`JtC-pIJSK2Xy-rS!P5(PU{$QclYrZFZ|<30@zRcNcz-<{u3gZkcu88KuxxG?~SZzPZQD#@MMfA=5ttZ`<;9OG*~=ST!oN zjl#ffCZylVz)9j)FO!p{O=IS6G~oLlVZ!}~nXuQVetAoRG+scg>b@TLD<@%_yB$KE zW^3x8-R5baHS*ujoAKeh9fxmoJ#+n6u(3Bd7L7rDO*s71j#AW7hB?ggVW}FosE-Pz zpDC5+Si6=AZD_+}$@FHw)sj7Dq8a%<#QWAOw5unx_Zj7f$o0`E*Vzoq@Jw{!zAk&& zEE6hG=j%nx_o*4bcy6RLV;^-RMU;i8zuFpucAw4g_+W?sH-)zLextn1Bj?9HyZdnV zAgk%yHY>E&=kfAxvj!Ww>#?|-8C_;m&%2tvp^CXFF6zYib9G-sP1FSHj*2O?_vabK z`+}M{EpzBbCE@BtJG^-=we6iK6R&8Hqt|0Lf8OaYs88?3^L&s=`cZ>6!-tx!2jtes zMGc|;*S$%y48EYj!wGuGCvslrnC;e?p0<@n(M9le=Dl!*=R>hFnaF#=^}lkTZ0@f@ z#|7m1CYn(7nH>$5@cb;kS8fGp(6mVmCRR0b9r62e{nv{$OZ8J~)NB)jo!3nWV&54{ z%rx9-mLoUR=+RY=)Cl^s7u)gYlS132BXRd##AgRf8jyL@f1W#=i2=LJ}@n$9`tW?gOBsh?%JoHZ(V>D;I0j^iLaaaot}LoIkUc#j8MO@WqVImWpvDTm3VkuqE-)!&BymzG+8( z6bLTSqoAeT`8dlC;XeGFAakl3W&h?R$=I`3?DRFZVOGvtdJGyJ;JICzp3r&BZ!DH1 zlP@I8wC-jZyWJ?K0?iWUXO?qo$y+Q<5RWrS(t}^G9`{D4HfFj1-Y6aWo8;o*1R4ID zxjysEGB-6@UN=sb((TPMyh5VPPfnE5#AizMN|Y%&ql9PCtN2rcu}#(Z+pfY2-VN0n zsj<7W2JJrj;-!`T)1~yIHX$Z)P=jG}e9>H^#>|R-SaV5(I)NIzU#mvfIn>&(Q{z4V zp0-|t`!9U4gMaQpKAeCmRt0J3iPb<~LxcPBWqxWR4k50^K-06+ZJX@I=1|b%m zcA2=)9X%TS(nE2Tf3`CpCqmC0Ha+^CipESwG&U?`KEW70Mvv8FS#kPuePU2tsC)bo zg$dL3SkaKW$PUypwxLILtsar-(Rf6RyWu%<*0cC^J8^yU{}1OxBO^N+VFUGO+KU`U zMl>QD^6o9D$16TVG}q!c-sg)4n{k9(PwzAn-s!lnXPNPm=k!1yu5H#s+0=HoZ%STy zvKga>F^@6BjPZS#3oz8otVU)_oHe8B0De5b)|0YHm}fF!>~bUI0)3ZD=@02f9b^$R z4C9QL$b0Il-N-Y7y7r00!<;7SK9Ya~JkRIa(QUgOXTN43zcFjAX_+ux&BQ(8EV>$Y z3>0E5ywe}AU=9z@k}KTr7uIKx^UOrq51Cj@op8_2c9?ihwyl?mbG)}75;rPGtmbZ- z9d#m@b8*#l?2W$T0n(oN$by)Uxoc@-ee z`JOUrtXghG(Hr)K+N?svd3}AQ^gusZ;qVdVfjScK-b)^bYouXgjSO2HD4*$1Y$G1h z;-9*5VzF9kTkA=?OiyVYtHib%?1!Tic-+z@ElVh2eBqM40SfpiawP9Qv6j90Qsz>w z^lGbs@AZ7y_ECxCA}(U^3aq-JgwGf17Y+HME=w$TTE6T#qd=WVC5jUR|4~SEJf#=0DeLxu zW*t_rZ(d1$qd~QB;=d6X*iVOwo5G;lMNQVoP!u~Cj)!qNDA%%{KORa?pbn>qnG~22 zj$NB{c(_If%T@9L8R5)wVOHGRFg)uYhKKugIJ-O)S?_glvG=)4&a@wUg4BY{WKcz* z?SnX;_v}mftN%87``JTmxNX4C9n4lFelWj@0n1byun6oy%TYH)uD%v|j^#%U7&eoc zKV=O#IL!dfWdkl=HDF%rIMlCC4mLLyDdi2gLT}o(%FLZu5{HUr1KJTw&@y*sOSS?2 zH8Fkzk*4L(`%voNy{9#CTy zWW&34?A^y%@rKz9UT!v|CDZdt?&t3-=@|FUie-nacox8{#j50ft6A}PW;)6~p}z4V zySIZb_*j}@su(otuh72fZuYdl5`WhEQh{Y{ML6?Iic>ZhXKqbYHtnz0Vt zyyQR-dF>xr#Jj3Eux~5-%a=}^tn9?MYzOitIM}CWBZeR2=H|qo_sm;jPyb~TKaPL5 z4tAjK3J1<~bfPN%FE!bTXY4K0lui^K$A9~q*>e64OgZu%PpEA?)|0%ur{ax~gktY1~q zX4{17xa=}{sD5pElBDz(F?0X4wYI)x!{f(}j9VQAnW{?=KC=?kfgRB}%fCz|QhVL$cA zub)yc@tmGkPxkRn>J)Hhh!79%v8i$RKAKv^Nz6p~6o*1j;tS3DuF;lA$b5yy1zH_fA_Q&FVdMt*_=ALRmeQ_yjXlgMNBPtf{Ul=fS zumP_9)IE+jpjom3%R3PRsBM7Pj&uy&$_&NFR&37U9++lD!);bfDqzFG_1tq~=pRnw zei~uLf)7@#J#NLSYt&D0@4Xyh!zk`O$0aMCa*vvO+UQT<{_&*lIFcI22KxjqtJ#Jaag)E}xpCUG(o4ClB|F*{GTHjGtou;&umWbYR9KxOcceONBVm zi2HR2_vi`kt+C~qr`q3vwZv*WuXf@|Q)*9+I`H8bb4e!gYw-JKt#e|M&H<7naM;|^ z>K`qc);qY`>9q^nT8?e4A6$F!!P8G~CR(I$pH`{G-dZGjw`KR3BEh}imkHi!7}P2v z@80R#-L|)=-`sS%U|Y52srOLJmJ=FF@2F5qDYgXhHM$3ns1ns`*{H9r`h96 zSyFFo@YGfNEkjggEYn)tu@oFrDXnY#9?ST%H7#p;rw1Q(BwN~)8GqWfCP8{yljPOU zcxgaBf6XV8c%&I+8T~#1XU%eZZi1wE8pZi6LE_ueLpC-=w!co2*k(o? zO=1MGNpcpL<=J7Q^jeuLn-f#yk9U%6qj%;>Gn4djH_C5%HlHjpOS9D}^1ZK77Sv;g z6*DA8MjGW4{i`{?Ch@A|htV~OQ;hS4;-?Q@cl1R)_Aw>;X^X#8`48k`_A zMkKOETyMtT9n2`DWrpH&)@!UAO+}M1@hY=4MzD_^NN&|^!sOy+ayDkf^W)l&Wv%F9 zCiiaUd{v;1v@_Km~lcs+MICuRf-We8)e7J!*=YA&qSX@_ND7G zv5|f2z;W~@FU!Q_0-5B0=!a>>T$W5b=BCr*)-n?(_<64CcHF&5%xnp3%`kf6JhSlp zGO-%sHEmC`US!R9No&V2elK(3EchB(j~4#F^QMz*4Mq3RU)EF#lKt&{CE%2=`1jFB zW^6&+`9t0NJ7xvwa%InL1v<}Rj>pk3Y@wHag(Cuom<4f}dbBU+!|*$nHOUO>#k;b; zm>h>CJTo7VL+`c7iY6zl^j_F-vapp|T;$P85o4vk!BXJ^PHlEzfQh*FY6mv;cOvn= zhqMdzkzHPX;<3YD))iLC{Kh`=X{G|XpB3oCd#wQPoBXBBOFE@M+>tOeHbvmpL;6QX zl9O8;j-%tlaHS$^qtsYtz#4Gbo!Y$>aky88HBkxXAhMq5a@Y#PL!P64^so1|;^Z_Z zjxNeZ^FdDd`I0wU#7vXV)N1ch$)f~~+@zPst5;$*4cRG^UphMXz`3*_)$)TA9pfqkFU);J{$EH2Oc}IwveARiC~^Oc}4$9~h3DUSW96Y{YJR4d~aJ z8vn0+jtKf!F7ocnXPwCRYFcj_#$Beil3JB&W2yVx$Xwq5V)PB1n4aUnibyA75}22* zXV#U6O6Gj`lMOmwnc^ELo2?CH$1`Ti{GdMOsuBlEGjD4fdCnOMw0!M`*goOV4(f|8 zws0Ko9L|iAa9lEl!8MP1BJx95bLr{fUEQck9CQK9Nb|74y^jqymNL`(r4`wCY^cHe z^2MEO9Bt^ph&xV{=WCNQlG!wTwu|Efq(Y8b>aFpWBj?zg82n^_GEjo}9`$s0$<#GU zjOY3(wc8DcCn=e69)`lcI$#;sG3yB%^AUs`V(J>M-B9vpgEt`eeH^@9%xH{?Ls8zh zalALD6|>=1mK8D7gJcywL+p+|nYP*Z#k=b(*YVyj)Q4QA2GuiJO3@o0Fg;oRq3&zg zO|$HXNRgK8wbKv#VN6XwO!=rm+hAXGP9>*aDF!KHc?K$CaD1E|X*c!gQjL8y&zOUw z>DNnT4&q_4>-`nV09_5RbZp5kQ#h`K_ zp64Fq@%daOoq9ZfPOZuV6SJQ=qhJrQ*gP|C%w<+UmKiNlvyfxRM3wc_Ve`3Op1+50 zJdb|zdsn2^A#RvL+wl=`r4VAw)T_MmH_2jCioCyTltauU@ZFXwK01?BPUdWhTwiQ+ zYH+4@IzWBHSA{n1utK|$*m>JwN^RV_WSLw)S*kZr zk>p~j^5{&mcKw9nGAm$7G~U^W zhq#%s;*S}%d7oUqXo3$pfFJG6@XN5HSWG6mj?Y5c6y5PxZ98B;Hsk;yf*kvO)}+wWV(~&Wx>3sZA+OoTa20 z4nEJ1LgYhMXX1N&yV7CiXlznN6z{S`+WBfcpLt zLOp`nD^UJg=r0f0f2}@C-Pb8M9B-_^ig z%=}Bs#*XH!U)Pf-9nXB&7lGm^5-4j%)5m#4Ee9(G%FI+|=RRcqO>hBpXU|oZoZ#KZ z3bf4#!}3?uz;_@&9utN)55h2UHRn1s=l6cdISh;9kbfc$E8a2NeHZ`Sm9;)K20iy! zG4iYx@%wF<&VRd9i5Z9msDCfa-jvVr^{5kP8hk*Z%bcgNBtX)A17!DNmH3tOllV2w=K()0_QCej{#5o%@Wo$5&=Gm+~gADdn8#>w$*N@&T z_8_fSI$=ERB)8#&YdL+7Wi|4qpGF=#g2at85n}1*xHP4)Z2C`g%4gW*<%WLaU2=h1 z_~(1wQ1x;c!cK-WcPt#%65)8eow?9I*^e4HAA=Z9gGO;^#Tw{~&4AmL9rK;|Y$oNHIEdymQSqfsS;z((R(C&S9o-G&L&SxPAr_<1ttfZcfMbD9*0v<3#(t4xG)-#@^rA(78LX zpnQrnW~NF(_B+i!n&r^=REc{??H)5Aa?{DT_S9ffDmB%InZ?4KgsKzBqqNoIBz1$m zCdJ^GgIH~IYQ6t9A*@{zvbUHqjy3q!-{gdNf9UH|dp4im9itsrt#+(YtwaV z2k)9?^c0?bG2|0@Ps9vVY6UY;a?vperEFO&S$Jw?h)GfU?lDe_p&e8wi!y_fLC zb*`bnA8K^YWbRFI=DHYS;9ffh_p+HQ%zESa2YS~&vd=of{Gy*`oS8?jz#(SoPv zcqaTxWZ~o4Oln9nu`Jt;iV?)fjeMU*DztOIkjrbP)SjKE&^}-d;!!9h62s4{-oci9)WmTS;(mmZyV$DoKl1|MI?piMF6o}8nf zW1|^6Ba*Ph$hxBwy&b{KT5&RO^at}k<6e|%+5PY)?MnKkNq9kvl8YO~aezz6h>CV7adu@XuB=(F!ZjdTh1?j}M25ky zFl+37R;UWmBX0JS?N9UMz|c@gngM^$w_<2D>c!X#+TZ+<)?a#~mLnEZUJ*;$l#O!l zJ>)fW%1T@f!SnCTechXmnx!3R8|^L&O6ADX<6)>YFBZ$A({cP(HX^or%BC^-5;u>2 z<7UL0&sp(!3BOKVZ}B;oCu3&o@Qrxe)^AoEzfBDHiLWfCuIlOne*GD-ICPSkw)d%b zJLoBS8}gY$ABvFD^gSK7!gDMA>>oVkK<#`vQ$&YZr(>~hGjZe14isssmg3>LQjD1W z&8@MxGLe|rUe4@!QCDVM`YkP*ha>a@{lyCU>fh0aRM10ecFvV%<`Crb3H@wn^_Yc5*d*v_W2>O4Wr(tB(b*|>_2|^N)h6xUt^ig z&%P?3-?yHMzIkY*f1na6g+g(OXYo64dh{C+U!EHv>$D0SEJNIrSfRZXvGF3zd)`ma zTtL258xaa~QD)YENkO+NV#A1rmtgO-gEW6JUwXf^`y`e=E{}O;qt$+(3Z2J<3(b8oFSArPl18SVHnnuwa%Y(EH`9h5&OB? z5iXgTPW)73fcvv_EbYqYY{k5b0M;+OdsqKsz##UC=amlT+-PK7&L6q_JRHZy#G!&S z9jcRDS7YnQ)MtMrH-a+(co#M*cLsM0FfW=sQol~WrN)XdRPW36M*ZoQD%n`|xQ6)O zaEURD+Wb&@1E~9ZT#7xOvaZ}FFLdEC^B;B_@Q`==Top3~j(CaN5Cz`#)gieKvmH8G zQHr{)+9T^r-Cy}~erp(RM6x!RX~lt3e4fqpn4Ha*=GNZmH=H@jrRf9d^Yn+{A$(80?LokLo@8A#{8qw>r>5h-=JM5AP!~;&9h@}^d@5@sMl7?y|g!}7c z1sw)8;OoQM;0k-k@<%;oH}RHsX(6~BM~u2N_w_CMRQ7txf0@-a=j*WkW-LxDq7KfF z`Iz^;WLixH+!}>qaW4aQF63+nVg^e_F*o5{uADW|4>FOtu9J!R?r>n?bx$#F%9SzB z5KJTnzNaO1&}XSLec&St)#TH9QfKGGybE1AyvK0C9Qm z#>F~*QpPV|!aGx^Ol*AT9?sy}LvF-TTf$qoq*Xy3^u)yrY$vxf)Pcs-$-Z`1z`bq= z%J7`I&iZU)ayH7ItReT;=1I$DI&5xhz?dRdto+JZ83WZ)_hG&iTq9K@vyjq{vRJ%Q%*ttnb{;&c;1E*k1t0L|JqvOm76R6KSHqe zt^rX|%pKtRA9~PR{+Y@3Nv!Hm73!A)U_<-hOWE1f&5(QL3DcW0U~>J|BG59=D9@NV;NE9Zp(yLB?!7S#cwPl7+Fnjo^MtSB*?7AxR4GWuL zy+nPYRiVwR6fY^mRB#LD^8^!@c*Hy))*~TZlcZa=H&$+pLa#PvJRWPuJ?bTAO-YbV zZYu0)!o0kx%q}WNUpaf=Z%q?rQ6^_vj?&{q6#LUJ%o_4y{@ROulFeBJ{`BA{ji&D4 z5dXad^ULTRxn}f1+2_p5TWG@SqjoH&kJCl%N3@EXiivv6Xl_QKiOfTssnCw8W0dM` z>1FM%M{a}($7+%1XB~As)-3C(BYV-282LT=SEKEiO+DR$%|VPpI~tzu7pXdb@oBV zBx2>ms9%^*y-AyRS*K-PApSHtU*EVN<<>)Bnd^Td#C+d%= zUn|E9@cALE+x})QRjvtlJ7%Cby&4Z~%>24T4=VeBlts*nBA%UTP-qhmF|(_J3QbRP zPSYzBrsZWoz0-xE4UF=!pavbsM*|g;@a$P8svUJ<+^v1`CD#u(=IHT^_|Dc|)KKhm z;a(MLXPz?q+#Zd;*jv2M$-pW<7v{8%m*COVg;k>t^qL7%b~D$KI;P(p_lbFp2DNH( z-pF?9r_wW!Nd0VDtWkDcQDJ9_9^0rBw5=xYK1QJ}$eAJc%cwbPjl9BgW~HCCqY>Yi znOrA^k}8z07mdwLsK-pSBlNQie?pB?;*Jmg1VuqhU0Vxc^Q!GGxF1fG&9hV}V%KA6 zFX~dM1JRyzA!k>D?4iD|>Rvs5M4FKGE&~gwU;EI~C`tV|bMkg-iT-4|5;&_GVW3aD}##d7lJRr#A0tG)ztt zTF2V4-iPbJCPO!UF|VRLcup_zCX*JlA@Sby!2m2=c^FT<>giPRA% zX274dw`wQ#aZQ=G7Rz;#Lfs!Rp7IM_SitA;kMu#aEzC;GBd^km97iRE_SVlt8U0#? zSFh*dS!Z%BTbbp+_0zAKNnS?#Fo$w3<~KGWcoO|f^xDqm`nkrO4$t?|__~GM&Q|;X za$0Y1-7Cv-RY;X+Tp<_px(M+luID~&jZ$)v8v6^=d-t!2S-f^Uq2CC5;wAYBHB&st zzGibj#@lgvAp5=ciL#13+9c|!&lfXeNI%XJxI!#5D_)Af_90%y^WiD=l^v+pW?kQ# zz4F%P%uiHsee&mBMU1W5D}`2b(j>L^@!V*`eN9X^yrmtNJ1Dfpa#E#V8_q&2LhTga zufpBg1Alj66m@xB8~Gq&aTL~2Kiju4UxzrJlPk=uKRHw9bredSFmXm7^U=5-LWjqT zVt@u$?@+(2Gof6a4CvJKY*$K@!f$-IAE{&AXF}QIe0|uH#11q{lZEW#mq%l7xEXF! zIirR8?!MF`KYOggpmv-O^vHx+Ettp8btU}xZ(JugcSNJ!CKEd9Ie#{gxaF02xx1PA z?$*&Lbkl^-I-c`|724pQd*$j}uAlaL6nA5u9P!3QHK;eNpD2Hpdn1tjUSqDGIW4G1 z=Ig)WSAvu(!EC+CoV{aYo?~VP993O-);L~*R6bbRfj)LSc{)D7=j(jjpkC6#^SO8{ zJ#M~azQ_t+@%6uKf|dKRI@jC( ztDdn>=;`2$ibGDX%+0Wz{I{!Rb410E5r|9TT=SvcyHrP{_u zryA`z-0H{dVyzDq85vym*Lus8;6s+srv*=+y5W5~r`q4G>@TiZRNl4I99~7!&fS|A zJc{dVO3P%ae90_GiI?(w66NJplawhyZrYe62dbIn3+L=K>y;$t8%C+}Bt=}4O;Tj8 zS$eGU&1W=UYg`{+XOMsG0A|d$r5|oB)5N><=E?ZIk(;LEWLb!XXrR$RW3c2@qQZYLC$(QIpsCfAP(jXK@D;257doAk5#9mkzAU0eJhqaGqL3 zsF<^JhnzJ(_hd!Z73s|AO(oCm;mFB%MY65c* z?o-eF-H!4N>_~2x30Eldb*MjVLi|HP{J!iUW^80;V#H*g>j!yf@jhPGh+MY9j!m`i zVNSa&bO^CyPq$2LnnmpII?t1Z{IkQ3Vi*SJZJDU@R00pL1OL3d3Mx8 zmRsO2C5zXW=D$2-Zq2$fw6DKBJE)QYV>HrYgolj2Qb+u3?$R;VU*^_oBpts7%Gfzx z()68|T$|}BJ-QP+S15qCE~z-uCAt5SYh@;5i+wJcmE)3=Nz_cu{Uas%B9|a2b$(N1Yb7kaaa-^KE@M8B5v3e_T;7hLbDXl=}JOy47 zfA(Zg)i=r|SA*zn4OXJ^d4B)J3M4oEBX?WnNe=te3CvEMxmmD%if_L3uR5{^IBLU4RnDE#?(dx*8f zq|j$pIuw=0>yR&;UEv5pk1g~HPT}mPOdaOd2*d4H)IClM#oGJqmEW;%I?Oq_bLd$k zr=qSFhtu7ujam_l3x^CS4bDJ_X6|A>y_MI#W{KrGWabQiMY6v!(qq~r!iu5njV6s}CSy)IG4*uxTV};^ea|Jpxk8zcQvy2>YXMcP3c{avR zVdlaE2j;Y=UU7>9$3JCrUKZzFRiy4Qin$pd-lKqq9?f+Q;9NFwbtlZZ)L>a1u$`q| zaTd8}FXlyUaG*VBn|ul)M-@m-)nNy&hdc0_eX9@g{&`Iu=s(Yar&}GE&YXTr0gVK_ zt}p&$RPv{)kDSo^NZVYER6FY@Pa4z}Be@Y*DV3C}?=AiF0|hTMGN87%SeALnlotM? z9_uYt26L9BkFPA<;wg)kxJ%AtAGtSx8pqv@By@ncJe{YO-$!doV0lkz*~D9}3{uP7 zjs9Zu^OEY*>PvLETK4ZFR&Z5;i;WbV$B`$M9e?Com>cQ`a83vReZ(&2BW2{ttJVr^ zE1oY?xtH2@cgav{6sIyX5D>+yo8x&eJfAJfwq-I9eU=P;BOWj<;*+Ro@kY`rSg2 z`CA9io18fvti!mBP&_FbibKUC5YUDHJ~0GALv;x7(_!=q;#=>jp)AP#_KsL4ap0i7 z%z>;!tieM6@Gt|iB8Zz5-T+5`=922;aD)46|5@r9xervw$k(kS{&U=bx}&Hi*2cj) zkn=8@8t{XA^f9raL7faZaWxj*>lyIiTr3*YU>*nm@An#JtcGyzm^Z(Nj#|k91`I1i z9b*`^8B?hxZb_c&EA=dm4Cq4*O_ym_>UnI;-?k!@8B`yqrepOzD>}8}><*O`GjvuQ z4P+K0F_j5Lx$lNsvEv*0r^8lU3r@$`p*HI6IXBwIeeyURZ=PE5*SB<(e#d>A&bc`J z+>XDj=-!WW@+PID!HINCpGzFOCV90ZHVpk~#fez@re|?aZgQY9@zQ^*anJniKstXn z7>L&dIB|DdHk_%%{wxmM{X-q%nQWYNIPm4BgBY&^y57t(nk7 z*Xdv>U;Uw_(%e3la^q?S&stkKt;VNSr|XREE$ z(bQ67Q8~-~$EM)x3#+8vsB_V>(|9BJ^D5t9@8wrdEZhFrGWLp(rA_|}mg#>VY}KYh zx8N!h@3pEnqIFvH_BoaczauPBktHmx21HoK54y_8jGvYo!4q3vEjj(f$q!#GjS@}r zh5Sc!+e9h|bm zd-!609deBcYG{Y5k=ISdj6G&}J6SJMAJVZUJ#AiUoKULqHC=^GyXcSM{EH3j^}J0Q zoXb;V?GhivrTM_?AoUyW)O5@wesO|WQJjicCbJ-yQA=sjW96|J*r-+b%v!NVb3Gac zMZ@ig9{ze}Sbd2`hrnnQzpF?65Mmkg$W@hz!K|xMxKfxpnT>i>b8-%K2lKaGFC%KtxOM#=9cY%6ER ziN(x$cJ`Bvkq+eojF<;sZk8%oRY(wnUG9PVqZHVn($*9+0o-J^SxOoHlAZg zEvp?v3T2{hiA?Nf4VpSE6T66W;JF<=Ggv$FExzTX=9LR7X`@0 zm;TI^Du_}m6xbZ7z!qj`&wZ>w3^gLJT5&iJ_GF&jhje5%W=4_1hDc)lk$0JQObyy~pAUFflyf_GI&me! zL2RX=Ox)@(@5u{2{^=*%TKLJ_c0MxXOrE$!6hNItZuq$(U*07vP`Ma05)XzmCng-7 z{^+o2QW*Ll2*a4c%;ex%+&wrBA6N64A`KYc+yHM6p7q%_c=Nn9Eg&!Q-HL?yXK?Kj zXHai;!go98Lsg~Ln$KZ+PfjV#iKO}Dp?-Nw_1pe3ZvtmZO>H3gW7P7tBr~KsC{UQ0 zCtZ0DUS=k;UnS~Pp6JkM9`7^eZQbn|2ImLfQ}Qy(O z)+Oc-_M~3VXodTebcF7s9;D3~6#nZ2_D~mBpSsVwC8z~iMt#b12Le8MOHY@VY#-q- z_m=xf_7{zebp*)oCQ1xFPVYjL8&FLNY3v4tn;ZJ_^%*lc98Z>#*VquoS(IT&_N8v` zAT|9(;?V6AIikk~jN|WD?oxX%)Ks2lJ(ohhA=ZYz)DK=~Z5P&wdW(b10Nc-*;H{k) zaf5osNb)Izn@CUhK$$IZ#nDDKUy$i5q&yN%@)@ylKsOlq-Dk`I;}@USUuFN5%OhoPV%Tk5W^aYu7pkZp8oA zGkL$Xb~j5$>MmxKW=&5Rw>ldvx?3yR{L1@$Ns zhPRn`yD^;2bCM;y8g-w?sFx{lK&qVQ zT{zB{xr>}{)J%har)W^UJbj$J>x!px?&BPKafy>hjEcc8HSwygdRPycP`N)}lit*; z4DbteCDkQoG*`Alia(v^CYCP&P2){A*$Zu_NeA7YKvo{rk(hp)ZWIP#PD z@d;nteeZ{aRrHKLqJHN)^OAX&E;*&ggiA5hsU^WmT=K#|&J694gxi`V{QH64PVxgy z-|-m^Q&;~o6L*GC^GSV(atFURwXm7p>0n-=5`iwTe~I6kboo^ z=a($aJ{Tq8JawKa8eA$uy^JU4a;LI(2xH#Xcs;<{VAN7Q+RbA2=r=v~YnkEEDhYRv zGMjM%v1;Nh0UgY^UN8ysPf*)*kZXrJ)byKntZGH?=iix}O`_0F;F=kuQ)-pO*{AZg z>9Udfrbb@U{gW5D;l{FOn!of6R>?AQjKkdMpFCa=4Hvm2u(}eHiYe*iQzE?$^@AI9 z2#yNFttnx|sW|JtS{Oe6LvD8j=Os=yAaH9OJoA`!!+YZp&%tl=t?=c!_^s3#H1M!t z@I4#$4B;$Z=Kb}o&kV#6C$^iN@XXCdy;P0djn~MD!a>qJvXR`r)IhFLL%60lXIA!f z$;1!^-k%_@(at45ausOf3P)PB4sUrT7E0G)=ocNbsUd9sgr29p%!hv$3tMXgjvq2G zqaqIafmT!xw;|}J6$3g^``(To!5U|<{~ERCiyauZ#)%))ci;2>fMz_ScmMJiMUe*5 z(uvgdr(El3{p3zQxO>38GYy8~~TIk=FyRBM!2dRc+IJ=6*^>knPSG4edKeaUZs zHR$jp!+;f~+3(m5c+Q?ExlJ4~IrdS(Htg=ga~U?Y+Ga(Ci@eVQIJ4n0XWxZ!rt>5x zmTl(T%cV{{EKJ?`jRsOp=_^Yj8Zc)$K-}YkWa--gxk8^phPx62uJAQkszm)uO5|7- zs5v77|MKpt^N{|xEZ*@edDk<$YvPJH3|!58n;yhVyyM_sYXfe2Y{1$wHu&}7>2b_Y4hnO9Tkwt_tC78$ z0`U6fhVA`wWsOzIxwvkq?ctJJT_WIBoY~Zmbo9LG_+CcfR3*M%tbc;?nAem*O~)SQ z+KW}V?r{a~Vv8E-a7vJC@TI8eRj2M95U+g+R}#GYsNXJQl`{G@mP z0QoeqvD9UT<*9Vep8lqi8w*&A{o;G1;S7_LoRM(PCEL>#_}7y-({~+qRqTtSX1-sS zId7zq4v$a7q51~uhsf0@w%LGAe6Osl<4`V@IhxetHtuV~#7WHd8e)UJsf}1L^ZAQ@ zKqBvWtB(_F3exY{p7RKoCrQsZ>dpHckod8wqWzpGeOjkT&089bIix|q8_d?IPtD#Z zHBg8+HTU*CBeP33QHvi+ogB}j%#%D9EoQt>GT*!yXA$PnXMTx3^eW7VC7#*-KDB7a ziGOnMFUn%JuRH5xa?VK7&P1xjq5weF%Q$jc!B-JAm*-LH$#_8 zt@+#}ESf{@po@8X8fNB>Cr7+76U}*7RC424xP@5|M&=8z=lnHlEEk+6k9e2bv@B}V zID>n~O_MAc!Z}XNXp}=Ka)+5Roos5%U+M>Ejt1R2Q$JXhnEFTN5N1Z>RKaMJtQLbs zo-tTilR1q&^*Ftf**3432TweC`7QeG6OwS@uOw8?&BT_c%=a6S31bgx_c~{xgenv7 zcqaFvUN4Qlg+q;aF7iy=yIP^$m7FYHW+Zc#;C?yu(Ihu^BuSPzSyFAj_*jO0+CJ7D zi!`9O7Jb>< zD|dsLCw!keLF#T2UT5QbO)ojzfqK1Wq3Cj*o}@_PLY~=Z8tW~SYyFXH8$7MiiW@vMq)BsiOwGvRL7EpBRmgzbsGs zBN^92q1#J+pNAD|Ts$N8SLa-b9BDm7hZn5bPj;hDuz~}{!|KSV?=ItflD1o+ zzRPp8VSOt$7l`k3T<&8T#uCADC{W%t@%>FawzWb zj&E#8$56g6`V>V^dA0` zeWjJROR_pLuk8%`ZaaI)OAcfVV}8FjN4}Gj*f^0`rmq!t{=E7?Pgy+8C3RCnnc2wR zW?ni1r}OzU)G}dGzU<=rvb{C=2I|yO*<-~#@E1L~n@ykT|DaASlHYgZe?M<~m5j>F zlfm6WFq!#!x5xzyWIr~1ho^)wL!wAl2ux$CJFCw=j`#1K7HT=OGDrIE48^Wv1{j-J zG0u>U8w=`*W{pe6aa}EM9gCIysR#T?zw~;wd zd5t(5#=V|gsG2LoRu5SUglFSUa$Q-k z&6Q=*p*WC6j)nc;*&*3@YW0<}2I>ua^@gq^ed}B&_DFga`npT4qPg<&Z|YrtWu zeHO$*3w`#H+{{1ns4IW2=JaB4{k$c9`aZR`{Ho7+mn5QRm8(vr$e!TwTG{_l)A{?IF{Mdh{f%boD0P7+c2u0EFY6A z)3$`7wY%Yexvphq5(A#(Ek{1)$$~Lq*w3FgOlL*8ZtrpLL0!4PeY%Quq~{*yY!0(x ztdsiXNN)*#>5@-HIUm`VIgh8Us2b?NDekY0e4dIq%#D3b48W9*bspI`J&ZN<>U^n0 z-T)O?d$wc>Lv}W1p7jtV`3j9M^{rD`pYKaY(>I(8)UJ+9oRKSuA30wkpZdNtX*ff? zde8zdF;fqCS(qadPmJD+oYPctM$|Q5OI2WyS15*Tj)jqY)-qzy#s15on8H~OJwoxL zya5Bkt(fw6Hn|~hnK#NMkvSpopFj>EF&zc&WW(CcQ_Oq+NGs+qOpY-id?9mG#}MBx z;v?>VawUFdC?00<^6Y*~j5D@#v*XX-BJ=ElWSRZG6Zjo2At-48&i|BJHFMEdwiV}9`?cJ^~^XaYK7~C1OFte zWrOpl{7MVOJcR+Cb*zYZL7j4NU2*u6JAEF4E!C*YEr!iUlskC`J5{)LUb_RVU|N_8?L@2S5Ple zI&ASlSNCY@1E^~YWnMD%GRw#BlPP;tC`nBC^)vG1Ui4Sjqdv~DPoC9Rq1Qa(wXAto zf6TzjUJ7jidKrD0s~D6_ofqqmCnf0FzU{(@-NY?6s4?k$6h>4}LU=3Y&`~#6b7i9J z{N;nwv!hUdv=Nnta9%Kb!&;$cIX%W3joRqRvvLkWIqKSmu|C0Gaqd>3jyVd)Y$jZ< zO@AZxL^CsuvSyYKzPw^?+68(w-`Ej#IUfzuiQl(jPTYGvI;zd6+a&|%D%00ToZdi8 zB8;`bP4=!ysTn9xRG|$^Is#gZK zEps8pmMG);tMP9adNddR=drgVsJlXYr=n5xPubfSkHJztf7e$TXg)!q^`&kuU?j7t zD(dlJzlnDV^JSG&rE{nW+0m_Qw+ zE(XQI>CxXxk0JG>1!tN>(_D?Q9reg7L!HqS>iE)Jxb)sAGwP{PXmm8zyNF$N$Y54A zJvc3rMAcV~CxxT2lJ8^ta68^5x#01MKkt1X)OXPL8UAFS9O&+Yzzb1`szfa80dqnl7223w zK0o!jtD~dg_+vsZu7}yIMT=#|%ZD5vY@_bQtuJ%AhEey*{$@fS@Tu3r ziOS?$5bF4lAcGsI5tsP?k@nS5ZEoAQNvXTLAVrb@73wYRnyI@$fO<=N>h1=Fx+_w5 zBm#9O5U9Hms8F}lK;4VIdGBw$_r`etzB>k^=LSeZzWwdJ)?8CUaf>}v{ASjdvzc=p z7cafLyJIZpBzYT+2=b(#AbDOck+EW&=!O%EsjsbR!lla8ijC#<3OOKO$fHco3B|(Y z#H40%{f8;E4=%*Xt9vR;xl4ZB7J7nJBIdn7_jCB!_;Bi|L=ZkUUwX zkva(v_>eDLsS5Q)lWmxrLBGhj{W6^E*{5R|n)7vsFC-t3yx<$=SXp05jp_Cf zJue-LE*GL#>Otuk#TgWPpiX<}A5nyUg^>klt}@A*01x^*g`rt7os=)Miz%_Fyo;f4Ps5$GTVkx6&2cluNY)~ zt{PT7^-Y}rG%rYpofz5hs5qJ3Mumn)nRg#e-$@7Zb#4~IG(AS1Tp?!pA(Wm3MqItl z-0-sGrPhj-Pj^(<8L!7k^64h=zSFUf8;Kaf3=PJfPw{g8gt~6Bf@Q1{tl;9#+T62G(%JaE5t7)Ei%cCi8d6SaJw#(0@%r_b+cdgHk> zpM4$kqsjBF&gZZCh~9b~!mvz5e-cmTCX`lah2f(|MMBM7Phst=`zl@%8JaS zj6^3(?-LK&wSU~xGUU=BU!6W7sr-W9mY~RimWFk&`+lrZKY68YMAF{THp{{y|0ZR2 z?$mZ+>4la{chW5<%O7a}`+lb7Rmpef7Jo06{A%?|%hWf;+OIoO#Ztfh#-zc2KUm(T zeYGTJQ4gN+xlmN9yNBvC_Y%S!(jWd%{eG@imNcal1(t%r?>5 zFJ9(vBF}v&XWT6ea_4Kj^b6tr_KBXiX|a;aGcv3~jASmOuj3wrgwHU@h2us!aw=AK z4Pd5V1*44Js(~x_otE@ozQ0P1>NPa5s>v(u;|b$-dNG1oRg1}AoK6qj0&)|ZF)z@E zKD#`7gD>#Dvk^}Y^}r5#&i-^DC$T3rke|s}+(E8>kOpDA*Ivz`=MMdOKKCV$UZ+8E z-mk73=-*g^{Kg~9oPOeo(YrMG_a*C*iD3xYM2zaCo_;&@RxQnWGS4vYXg!oa>A_k{ z56`#s*m2h5dL=!1P+|B`QIE98p%``{47pBv{HPR;0w-o{kdHW}kshNr5Z_+FS@xVz z>X<{}QH)skV?D8ya9mkOjc8C9HZRko25X*g#ODv3U}m*T7&>@x?;yT%^ST)a!p(4d zVZ@dx^u$?WgnLC3f->n}y~u=RW+RrW%}8#@d_m$M9fQqCy~_;hIVQa6!;Jb?oMZ3e ztebVytyAPEcIWrFm!CXkLNb5eV;p&rZTWN2FdMa zJLGJJS8xVgezKO@OFwESa<13fP^ToZvAdifbH+62cLq*rZOG^S`I~!2-y@muq24yV zQwElBj^K1L6X%Jcg^&~JXkjhFb8;7Js@x|wL=WNInvXp%%lxGZ8HnD*z3VyokvmvZ z9LM0BBxk<&FUZQE`D)mF0C6l_Q0VDaCu25Pk71)zh zAf1_wd#*hF;(8Uxp03njO)8Z1NCozT$vRZ4+eBc7}*tHgjE z`O^MWp#-&~4y%O%*NZ6VZBiiL+9?sapIj~CyKWu|45`g|0X1K7#h5MkvOvP=Be!t4 z0xlgDSeVRNxFa9S^hdAdoTvJ-54_`t=;QwA97K(qRfnvjoN+42XWUG0w-|q%=|dkl z_BRQC{INw9z?>R?be}=aRDVCr*~koP3-h9O2H@&hdi4i0Yub%IK^4i%Ivm zB(f?;VZplyc+RGGTr&Ib<@|m2&)p;nKb^?m>JovVYEg)p!nr_s>gHfS%Ck4sxh`Fz^qRmX^)jp@*t~q%S3hEe_=3wYVJF*IyO^{75h%7!y?6uez8;Jew z$;P&HJNl_|FqgmAOr4Fy_u07cm)|>J$H<%6a8YQ888?y=i7J^tL@jfBc*&DdF5;nV zD$}nulzVr`<#lA%GqyM4xYkvAK2u2;^P{sb zxXSiYE^;ujsjOVtyB60=_9OY=R%bM`2(ZXENw{wz!%~H-#c%Rze7Krct0ttRnAk7x$$+cev^671% zY+R?rpjQPlQO6m}LIr%26fh1fkhj|un8^D{(JKJIj|bojHHyXW1fXP)4v8ZIunGQ{ z)WaVmeRU|Z${(di^06w+i{WF>#s@H;YQTRzr2_Wp;8fEe1AY8apSa1tXsC%45k5vc0wuKoh`NUm`p%m6(ZnQQUKE!et z^Pcf^j70mR?B82a%Q-I!x!%MQiQ76|CGVwuB(|O>wo;ECB=4Ca7DR5tFlJJmBj5L1 zB!c<%dltP=|D_jWF>-{5ko!0-5|~KbqFogJ)pHg(h@Kb;^ustyj$=pac!hlAIlMP} z@G;_S6UV0_ZFwqZ_SDZSQ&Hj*^CE~*g_Y)7C!ggYJx+=f8$7s>-Xd8ks8cQ#7fX`I zQDBAFJuA|WrDDl3em~g?3`s>XM=P@GlNZyQcwZmR@Q4?UqjtDFRgJeUrC>kr%@>^U z%_dIh#~Iek7vxTsOu>NVydP&Udn}F`R~z{Wej;`{!lOS?&Rms-{>m}&WQ`&V1ij+kUB*PK%0J9w>E58%8Baz$vq|Z)TJODe*F@NP^7R zL~S4Ivo<<{3k`BFMT z6v1Zc??G=ybDUgQl|W6QS&lle2G5U`lw)yHE1&wYal{bz#))6E1euyn-^L|IF(eq} z#G_c^!5;X1fwMASdTwX4_B%k#!jCzjuQ)TSqDDg(HOhFaVCVOoXAyU?s8D988eKkX zQ0uxH<)^ARYw#eqUWIol)VP$T7Z&k{rQV!L{_6?#W;N1RYjAIYhWvOH&M)NGIt_*| z_QVS(4f)GnC{@oB&8efw=f6eRPt3YY53eSAYW_lq(Xt*SmSml$M|0MSk(a^{Uzc8r zC8>3ZptmAtW-ZOk#&qC(@jP`e)Wa?2?`rt-M_ZB4Q#Kquy_g+f3q@;U7FUUfseA7odJO#(isZa-M6rKs!yY|hZzz604#V!_Cd}qc?#BZI?rtNl#G0>1 zJiWDJsdX)5hUJVArnZ->n=tab5iz&e*A6$L z*gkqTR$?zj+-dC{YU}=`pUYPxvNjp9ygB`*nv)+nlyk^56MDKB@w^E2q`Qqc#@C8g z5V!Fom*#l}ihpI6W(@N*I?&IXe8fT9nQM1A16NqvZ8*p}l0BbYn}KJgGBJ;jB@Sjy zxSM&hi!*U>mJJQtW?L9J; zO8zF^V585soqWg5w*SLt-0a*~jO&=qo8~SjS81dLxrDbk<8mpjM4dnd`h_SkG`CR7 zv;OjV!hGfUK=ip5fQ~f>p@w@9o@WN)^^QP#Ek-eOjeB1<{TYc@7v&87YjbkOf3k*{ zlL~X6RP_48nNLHW@sEi?tFlpPbq>;3@=WHLedjzq2z+x8V!-(5AZsJ#&Gp_?-*ftO=Ytzeja}=fy zi^AzGQLHVZi0yF?e@AZl0oE3$xi8jC!>7Ymq`9Y}OdWbhbKiUXhV!)6InWXxkFC!7 zU<|!vQ=7={d~eBcQAuU;2m5qU%dbh!@^Fw6qcZYjB+c)_1$3la0fH@XigMbex!chF%@q(gEM8Ok~dFo$PLy@ zZp5rFvhKJ{PB?3tiX(C`s0DMdi+{j^>OSK8Q6nF}X{0SPqQ(V#${CeLes@>k&3yVM zFIJ-G>LLh_D3BV{ieT!RKosrG45l9e7)Rf&J1qmLsU_d?F}GPAi|I3jW zVdB|$i}hS1aveNVvF>atM&$5JnMG`UI{Az5=-XS!4AB?ai1sEnpFv-TJB{RLq?`13 z>LtUkwve%op0fD8r#M|Jlol=M5lIe)jl7U~2@d$#NP#Eefmp2%z*yG4l{N-plR5x< z4+SEgHR;qR}>o(*xF;ompQx(kpuu`LCVG zCvqc4h1crUJDxRDG;-sim+T+wAvagK$>c98@%Y(ThO$R+%2#5=a|Jy0N(9@K7`Z@+ zedhw;dy*bkr-JZrgMs+HjC0pgIyB}CF?eefZgLGZ=@x}gzLBV#5QT}0Q_+eX&*o23 zQH`I?kiltqTa7jHnrz%F!+a|>J&ZX=IY*w;zJ2sTsbP}S^slSkJYKrHnWe}JgD8nB z)NHQ7OYXUqlF2vk>`6~?Z)huM;8Cc@r!aE9bII=xq`%dgaEvO#d;;!48@c}^wlHJk zUV6!%p#SR*;)Ud2Eb+?3(mBLsT4!Jy@A)@xnHfxuUeoWy@5wV5--~ksYM8qbFMaCD z*KZgv-Dby&+Se#W4;UppJ6^u`@Pvzn8phsU_@HfsSqGTy+){;RzTtQr9ge5d=}WXZ z47Q%kRcN4xGkf973rz5{(l?3yZ{9ENncPD|8*p#)WiLBC6E*nWTK6M2C5=5Vu`|m) zg|;Ozx^;D#14AtN^Ct2vi_mLur&)%O>lx&nAg3-fM`gZID!G$S5TM57isa&_d&2RB z26r4aP;k$mF+Utb?$MudgC5mdhocwqg~1cZIX`T~fy4A1{A0$)T4wzIX@cuaa=giL zSe9%eU{ds5;=S9vhXO=ftz%B1gVG2Uc;@I5yvx`zE&PX!*tDbe7p0?B_BNdKHC>l1Vc z$_qpTatOmz1IhUgfIf^l*!huoKA(QIwWCm)=hjYs9Un|T_=~9+$^E$wJz=*vq+v`m z_RSxdJAEM=<#qHPd`0aM_v&@5(OnGmM!f7Tt6dsN`R<;Qo9-gF?l+Pa``zVNav?PW zg>s&}y{*JsYSmKWN^qgPcMHVgvjOO_mp+j{1IRZB!1!-|2qu3qn`hX-B=$8AqwuXN z_vg`(_|lJ`N8eQJV6W2UBE6!7y+tQ#1#0AA$TRu@mB_&xZ4Npf&&J*y?$0;9#rGd? z=|JDXUF4shF=_-c9#UMVL^tls-oJ`qNi6Xn_LnJ}c%~KT;CxSqokN1Km^m5?%LQV^ zd1mPqaDV2$+&zLGSpB0ghv)s1_B`kRNuw4a6;D}fj6KY=b!{r1g;FC{B?nH$$Z2ew zgUs2?YPe1=!`2)u+TkWk70fJ&R*U=TmXi8jEnA`+OVfJPz}};`r?V0{(F*n}_MeYf_gthl;0^1bH<1`$k3Nn4s9|7^;r#h&DF4}t z3*-$hKE$=t-imp|7OL>P>P9`+RweTodA^srN1vWI?oyn7qvsxLuY)J49F7}vn4#R?4DD9xg*aClUDCwb-G~Xb=v&@|Gmd}^?(fX5QDtHa@Aq=2 zcy3*%pK!WDTScMNR^b01Xj5plKFqsHV}@J%1bLz2?0W-q)h@?M%~PK6{pbbL4-Jm5 zrLS-=HBPZ7+HR+}-^y?_Js6HL)55Xwsh%3GP_)sR(T_F!tSCp5w33mgHV-exT51D(GMG*eEmim}JfugE+NJ zkP2Fp40BAB>YTl-9m7^)g}onF;rOnK;V5@KPzIR!LstPx`~y z=kmRHDYQ4mET={qC03mv_iM7B{F@+q=v{JcswY;jQ)3%zjQ{xQbUo*V=XaThy<3mh zoB8_MaBNA}qtO68h6L-OElscEh2#??^56dSJa#2F|GW`8>J?s%rY65`1}5`bMO@`s z+9Lzy3KZHi{izM$Os(2)h4upYUZ_`C<(w$9=O&1aJp3B34$02*N9em^mbXhe)7Ywk z!yZr6W&U;5ZJak$_C!zmA3o0x$DT{{_3RXmHYs6vG?jCKWeFH&qeg8IeT6H~55FOM zDb0)5+Gx6mJXI2w3@u?_#p1qv)9#m-0l~!t>-BoDSJTLx|hq}DKNhTCE zN~uZ)sYUPOErsOfIvtg-56G!3O+IC|28E$qKV!JQ*OJdjzUP{~dh9tBjyj*{H~%qGfhmu5=vABy?rK?Htw3ayAAXl$Uh~ov zRJp*6nf2snaew-@$PX2_MbN7(1*eFImKx(MEx5POZb>cv03uV)yIBHXxNutVlN01`l~UT!D=| zLzeS>J{(AV%EgX1Yn-I*0rCVhh~XLNOE@qEUnbd6ceArJwB*b7mCRb%#Qx}3GL8~| z`eRVZ+A9U(bV7$p{`7@>k&MgF?1)WkC})}#%8-tJ*cVJZk9+;|p4rH{;wm0B@}2k$f@k;|EtoVB>b;V?4tx$JEk$PJwu{XRDVLfuY>5cl@+t zS`X$?5mPPmi~a*e$WsgEURg66_~9nIcI8UYYJW^1Ca)*IugMDHUi%%T)~Et;-RO^w zha!;MGX*EF65l%GD7g&^#Iw9VYVV9hpY6%04r0+c&N8nUan`QPWuDLHaZJU^q-=cV z9A)>_LMhXbe91HH&6-jd$mYqeB5n5nmeXASTPrhndlGrRSL|qhl-?b|3iKJl=h+g8Rijfdmd`U`XFX}_ zu0ZE%0qDTl$FpDbqYTVOlG0616Kj}e^@Fu8d-j$on3qJ{GT%wcJ^w37vzXDw%K_li(Pw|ko4e4unnfINJJl4CsFV53nuajE5evrp^Mh6Xfb|a@# z|H%8R{WZQW^Mbd`q^^|f(~}r-cVenp)f>vhx%6Fq=7+QVyYlia&i{I$9gNZ-bw z2(BM^VOEop`wsGvStpl?_K=FFa^-}L z-UhtB=a!M5ILD4Y+tl)UwE`^~_~YtrUSH0JN=Mk~tL`R!p5;nwXXc5M4`^A=nUgE| zq?;ScB=Qq`^weR~NaF9im=Au|j<)uOGN&E0rB?c*WK+(%dXpbIJR9}-J{K*_7w6Od zDC9n)Ab#-vAFkWs&QfGqzC12Uo-#iluOn9U@67eNTO&1Z{FO6#0r)YO{KslmG~)g+ zk~0_&)?0Hc1`!93fZb%p=o!p+-t8_1KLwU8VxE+qx>;x9U26Jux~Qe+pWpI?`^=`> zynpA?>tii-j_eJ(uP^_$-*2Dhr;k@n$Ys9Ha_7#K3 ztJU(p-WGtr?vZ%l!#aDmow^3{XVZSm^l%-@_KC!uF{~*=ImbHQP$m?ie}#^9a|vcl zJWWCMlkaijzLTVJKM$#@L+GRkD0u(=-9_Fm_p1ea^TgGK{<$l;Z*W~XwaUiB9o3}& z^gNl)^TMwTXNmsw9Z9z1rK_`;PvlGT2|x7Yb+1{8vj(Fb`-zKht*6FYtsc2kr~{vz zj@{(%RA#N_9z@?pdLjL~WW+`f8;W-#Kjnx~dR|c@@=z!qk1h8Rg8FT%-*zHjx(znj7tI(a~zn3EpPk&F6XDm;F6) z>#Ns|_`#n)w7U>psu|_^UKOg>qvmA2i8X-@{ofbjT5h}y>O%iJCG#P&jo4b7xrpqS z>qZ;p_YW1m(#P$786#G&q9(5@`EF&*vaYd)wH|$-4jQ0{r*|{|t}YMgldx3<-^t7u zE>A82aoWFC6xy0K<0ZJVJI)*mLz5BY6&AB$?~+39Pciagg&Hr&wWvbwLFXd$E1aRw z-YsvIn5QcI`)XXa>cx8Y$WK0Y*7j`(?CvorY= zHI3*}k=c-}O?33?ioB{qy(4;<8yRuJi+Qg-iPQMdSCLtuUA8k<+Qo!9rRmSe8gIa% zIMMXuyum#bwTKCo_{Qhisn8z1YLuK;9`qlfKV44~yj?P|cep}ppx0N>EDb&7=z&#_ z{0Z=V?jnzAkU>;;HTVoYdc8E_MQ0ljtI+0LjTgs24X(M+FDrz4%;`2%n6J=w@`#o3 zMm4?OsAo+vQP;`b3u0cf%^<%A(a(!BfZY8?=7=!&i0f_X<5+1sONDBwp~Nrg7kSsl z+&6`G-jX;u=B`H0Aw71tB>phZMjlup+N_I{p=(sQdM^wkZjo1VEFHIby`Jo+&tNYP zOfrR`Kur&Xem1;f-P?uv-Kj2WoZJ?Q6+3x-HDod}Ka?nHVo#Rr zP}H{?;Xj%A6}-N$Ud2g|95q5JQ1g7(fNM$V7}1aZm0|Hxa=Qv2t1_Qs81sTB+we|R z$V?rh1e9Y|*E#Zt`x`OQNPcKHg?4h(L3#g7gV;CpDC@>`m~VsQ;X;H~HA#`<9?;d& zGaH9<4;A?=e7w7o`Px|;9QqiFuFDK?IFOFfj|wrcb(|C|Rbd7_%hJ3#JK?&Geo%;% zvIe=gjq9YE9+PU3Z+OUt&ZBs}Hphs9pU;3PeQu8jS7QX zHTs3zRkwaVPYk5jfzi0Z8Zb-*SvqD>& zJmp@zFBbFu-B-?tgtqBWu2pDL+Q&)mN_SM@{BW8umpq0%cRo+j)L2~ zZ5D~s?y|NFoH_y7ODkN@X){?o&itZ>w_XXcRP;*Z*#dswZvZ`XTElO8P} zYzh57(=zvdmc?~a(WJ`bu3G{>lubVAYDx-qyl2_G(K-33_ZZ9WTJ@6(XWuwib;vi% z-i5W3o9$a^30N|@UHjoz&Mh45ncPP4ASu0xi?4B6>E!YAuO`*bOHFbg{l<5G>14~S z8aLWaDs{lpsq6iA8?}$xecKt)cEPmyN$u1JrQVr1v6qh%YncS;PCw78+l+FZzPz7S zbFZpNPaK}XYk!%=K&@fBVhK{Kkx_Q7iIduk<3*WA-^N)+ImSLYooC&fI|pP(<3tJI zSNnO1@^BZ=#Y6EjXG4O_jxo!nA;j$I^*G;&{KX-0vi)t0TpDbWeu42)zp+^~$J8h~ zg#L+r)mYJAjeoxJnsJ{VOz)hu7;+c`IB#yEf~krp7S~YYS|@rmJM+Bf+Sxr=gPQ@K z2(QD;D4t~wS!$e5BbR-p7hYFqhJ8m3vf8LICWABWVDcUtY2bL4`hK31Ku8|3E#whU;O<4a1v<lsbCP*l#OpXw}f6zl3ynR~O&MxSVE5YoDbBj!B6Pp)Ko zR0y2=vaVRIM|s{K$1^w&XFXw9Ms35IFk=7AyXt9%x}+JWw{d3i%79=eBkJ5Y0{7|1 zV=>}cX){v3(5K-N@rJcVYju^u z^L)sU_9Q;^%LWDa(o@+se9>~x_NQOLpbWU~vf)#4W)N}~@|ZQ(d18SBLb>OL^R-Xg zaE9mQ^gHPozs6m@-Kj55UmD5|@)SQf&@Y`{is3gJ$c=!8@;*f^I?hGCiQ{hjsh0kw zG&0WWCJwupqu{KPvjbg4rFWC&gWcuJS0@=z%U!1RZYnb}ykvWbhYZ}R5sPnqIr~e+ zTy>31e(NkgI#*dX&`qva^pJ?3ZZha!Z>d|!T{e2Ti>?E8_tV(7A5>uA_X5$9J5_zO z67!E1NHq0{f$UiW{>_t5{h8lqQ{W(d;6{I^-fDBcoFK>X=hs5&!I=BgT7g#NKknu8 zWy%A0>!w`%GZZFpC}ww{-M5)M51jKlYvh*j$F5^ko7t z@xDJQ(i`%LU59SZ{qePv|9>+UmdDZOKQ971`bUt`{4{K7i(tvKOnMb&?p=dhjHutf43?@$}N+loG`tvLUQ`4!DmFzb>P!M^lt zuv+2T^FLZ%D<1IYeJ1i}W)o8%$hpHqYG;YFzwE^4X5W33y{pp~D-NVs@wOg4=k}#w z@zM7%_-2y}%o+OGY|NQOjuiX7C8e|J18B#&-^`TWVn@?+w1EGMRUio~g<+8KI2z!GN`OtRx!7_L3=N`w5qXGEblGnD=F}>nF2Sz zEAaM>0**Tir0$%*61+@-wT+e7T1J6cp9*9Bg!JVJr)g#}`q zp@1`ajvC&NjyDRWdq|-qR^vRdJ#~8X3MKA3`Nqt9ubjpEuS&k`KFRy}R-Po-^Cdb$ ziP3G8^gSZ)WE}5T-vKb%IQ#kHk2+O|S;p!x{-Zy3b~&? zPwADhjeR}u=|1IyQ2H9Rw#@7BAMB5A)%-EBg$~a(QK++v_fiRBbec#c6LWn;PU7xq zk+{v7STO%BX(ApJAA#MR)%E!riH4UWVRR(tmzmO010qmkCUZo1zYQzOEH4}H6%~1l zYa&rSm-o^d`h}d0L`yGnA-7XcS}_W7p;6fOAOiESh8BZmnr7jhRV(5eRAq9q}R(zO9&cy<9Lk1CdZD2)( ztQ553{WX+0NP0NAj)I{S0SpT>H1L(07XXXhAuC?aXGT zfgQiPk~{3f3>p5+gErK@&(6jMVqi5}GIx*P58s%L9a(m?Yfc=hLJsyvlK)8l$qBn1 z*H=Ir!Dv9 zb+jBf*V{5`z{8}7iF!+efqN`qCbdsWgk?(ChL%MG2V1ghu4tF{B;2>iF^Be}H`YlW z(Wy_8IV?Hp_T5ds?+X|CuAd)dIsGP1njbaDi!%nP*wP@;l?`&-iJBqiTAW;DmVx!+ zWn^5ONNei5tZ}kDI8HkDh>_l3j8cW%k$rdR|2^Qa+_@hw#i*e&*vJJCer@8s&>Sxx zse6e$$t>%6hov<=t5y(4X>W>?=+~?%H^)l1k#RE1Y?f)WV@0Ph%0I>F5A|7%rhPe| z@>C(>g9pylW(G9pFoW6uoS}EO=`FpzEgI;rs*%B(FIc6);acoz{;JTYf(k3^YH**= zQSF)ng+j%lK^mEwP3%~ zk(#?)4=gRO$IL~cC`E0G-_kH*M|!*n(Bsb)au&ncJFq5vOV91ap<&E+rFKk74&#?F z1kR!N*SRo!ZonF^nH~$W*iSE@wvznENp_wqTqum(MHlA1gIOsU@N(e@B8cxb@l14c+y8`d~*4%pjE8 zDV2fxS=11&q^CA}-6cQi)%}!M-!$SZ-!rgciVdy{_}IV<_>^UDZcB$tKW26uWNyJG z`YS%pU_LHA9A8m)xygnxA2YCYE-{Y1%m=y2OzPz}-kan{*5~(zWFUJgGvUf-&^y`2 zx$*zyGakL{BQNT!#qEbXeM3Fu>@2l7_WtA2_akQq^! zbu|*>8q*^;)rwc#OD~p5LyvB(NxCzWvbzr*z!{tJ0U!w@l_awiPy#AUk74UWsK(8e_taTZPhG*yv z92|g8JkyMO=xuO@`+saCo)X6{)`;2@)_23tSgC2X;zw306x^d-e$yW%jx)tU*%+9e zjWU_pc=3_G(3v^NYr(qbHu;o2RgwbwR|YY=>kH>_7AG0RGkVfpp8F#e82OBTTLA^K zVxWTOFMW%52BOZLAT&)5!k#|N$mDgakrIg$)uYg93$NGaDEv6UET%dCGmom)HkCPy z)R+ur7B_3Of@-O#V$8AVoU*(U$w&!x?(arWXEuSonXrjUib^WH&VxuabLH)z$1(yE5xz0Qrj#>BmS+xbkv^Hi{UP z=CnfF`7!x$^sMyQYLM6TwkkrL#IV3D3(22ff1009H7|5~LEph@o>=SWiI#qPC|>JP zSY!ROK_tnfjWM0KA zPek~5VZkM4G7Z$=K!_fblgMKXrO%cv9Cya?Ji9?I|7e~!!~wrfH_;1#9E`8Lepkpp zeN8?)_v5Hm%rLD=E(rCD=SNZVK8rkutMt?)XE2D|hw_W53I7l8^FxB{f0ZcL^3C#W zMFO)J%`%KQ)9Fdfl;L$coJOyPdHm|5Mmyp(nbZhW+0XUUD;%5oxhzod+T}Cz`L_w` z^=33{VaBy1X6R0s@Gzfv;R9wy{3RE@+5>#!`uV;h10P0`LrBg=eNUzKgO%CN^_ALy zvPx~YNWMqM1bO@Os1%$c1{PwLmzz1iaWTr@Ku@d>@}LSRZ8uhdDNeCcJpEp=PrX4+D!vFPw{Cg7h@XB-ilr_)=rP%3XNp4dt+%+$pOKk z%z;xY(fg+obG7{M?$k{#(-E`L;gn|(ZciaU?i0Dx4+HRc4)5*Zc@ShA=;92A91b)vCT%^sS)^|^E_JwBL)r%1&?ixnGqcG~-pmyu3= z5OVOI=h^4d*+{78DvPIj$koyFLg@W*h7D0kKLSk3XY9rNCQ_H7}QKwyEc`a5MoY+ZgQ-E znT9!$dh6w5v&ekJ$uaXW&$erjL#q<0QeU3Lp;nk@q zjN$pUXhkIU?y#b~iQJDZsW|%6iovI?xcbS8P*-|7HK%vwPLH(b|c;}+LT zpTRlsn!~P+GsJNEA7;+r5cSfWA?nv}J$oJzDO|ByQ-qZ9Cis8AQkc!E5 z=rL@!VtbKP9NR{ZtcD*@dqp;?Y@zSyRn}#%$&r~szt0ATWu(J@GP3B0!d|BC63$7iy}eXizki{VN2CXJMXC3~T$#1;+_UfA-M3CE_Rdn z&c5_4Ayw_Z=S@JJc)fW4{D+(g7q34<5#z~q1baI z41EjflQ4@tCHudr!Fs&jO>dP=37AM+|LH3emc~*iu#eX(kZUHw27@1YohEV-NpdK4arQ&Qhyi zo@^uUsqr87O(4dzow!L?cX>KqiPPkNIj)Mtk+M_FpgZhQQdkblUxB5qc^gcS}I$#rh&DO-={OZl4v&{rFQYQ6bB z8!@Bfa|8OU1a;Dn_+gOPSwb){dw}>upf>TL?G*P3ijP0-gB~n^d*jH z9>&_A_;pEd;>QQL=OjAG$))*%lm2K|ClU!CQ_%S*aaT)2*+%?w%d-Jk{Wt<$E|Ir* z&5jq9-K6J)ztY4q0GDes7p1xtj zNH#hIHEEYdk~eYZE%n5w8hz7F4#32Z5x7#8dAN_W;Wo`#T9wO{ zem=~h-cHZul2#m^la1jwoTXrHf!wU^k79F}vrK$EQe#I0jk^q_-{q4h{uuc+0?*S@ zP-G$Vo!y*ee4RYm@210YK7Tjz8PjWI<4FhpUG(XDyibRp0nD0to{V#&=+pPpMKS{N z#gCfuo4+IQxses-PIjbhbCjds3grH8e~i5nfp>%XIk&N6#4=C0YgS^)cYj#&Bk=FW z6lC_Y9B+TZl$lKAbuQu>z>z>`Gb_0aD$lz^ks-OThT*7EO48PtlXI^10!_g8PYeC z8tm{F%quVICgoQu(2YKogQ{^}u{s4)-`erVNh3~irO0>VdS20#ewU9@kiojbaJ!CddsHYBI?>Z0jJW$m z^0JMrS?{>W^uR*V*6>Hww&V{wSh;7=SNw;gENa5s^V&Lcu_DnW*NS#VJLZ)luaI^9 z1b#lN!XuEVPr-~n)Db2%7R8=I89RwHglMkMt10+EUf$0MUNUNIp*+j*C$~HTfBzx> z^bdV0`n$=SdIgfaioDK4QE+-q9xijds{=@$+B%+)3IO=1S^8e@uQBfw?`1ueT;&n>qDQZqeuTtUuHbn0L>= zclH1~bSE2%qPqf1dgw5Kyh3##GtbuXe!O2#bUq5Wdg|c$obv-G&dE;MQN5;G?yV}2 zuqFXm@rd5>#uV0=%t6vSOFsR=r(ENH-b3|BrOLrbChk*H0(T>|&T(mRDc=w=mCc3O&6IoENgksm;%=_GdS78>+yq zTl9KaP4D_HDLAo+xKB4{aa)-y%Z&cGk;8hs3-_@QJH92x%gg&7&8Xd?YXj~rp+1pk>RrPDdDg)LPOM?PrjkFEM?P0> zAj35ps}ktyXhC^snE8VXArON9=P0?J$XG7LdIkusUd5DP5Z@OPla<^ zsA0WhK*b^%I6!{T+ac7PZgR%}XZk#@GNQ^{@{A@cw9CV&M?Iy&v*lrUoomFK$#~hqeBK^o$)o&bz*1rqL>ipaeGjsC-d-)dBLb49s+}9vtB=5`?g2=5Vq>&GGEr|8beWPq2tHvZ^H@;iB zPLk76E3^;>YH!qCyr|(P*1y__PPc6+R)U}NK$Fz0uf}>u;ykmB7}=g)?uQCd|2=c4 zJ2Q)FZWy}rb(4v2Z+u#aj#HR#zJR*UhG9^&HzKEv4dx!yt&)$aD$V=|K7V;1BUAEAflX#3z0;2mJew7}>Z{!#to+bS_4Yh>qM07p~98%x*oY!tpZnXLMoCZynb0 zKMK)gG}oIO^~{gL&}yj>f9&ZW`9>*)z<1a_sv)Rn&QZH+Q{ojVj& zLNR?2=L*H?nZ=s_H~C_Vl6YOX9^QW?kMaolVhZ~1xyQ)zcnzBMVJ-c|h=-$yd37LP zue?z@{-ef3^6bVwGoZx|a!!^O;`Z`5*%+us80RqeI~#FwD19wgv&ZNaBSWitAn!8y zXk5?JyvZXADa6H-anikk2QG9E#ZBT!^@ux;(kisgTOE*q!zwJ;5<<^p1OBWe|1^R= zkM!tRy;%kC3Sn65U_$W*HgqMQv{Ei}isRMD%v*#VW$5!*H{-v)iVNILvSbwbxoyaM z9d1Bi8FF8EKmJ-BBZECu*mpGq*MHG>FO9rQ;&x}M#z;Tb@H?GC@pOfWeGNVJ=P(Cc zZIIIR^_cb{4E4i|_&Ujkn_P$36eI7rUyYlmN2Np~Vqeo&v;i|o%F=5tkeLHXA-G8l z(OQ)ET~pq_;jyx9nmcMM^{CGK>py%<2Yx<%|22p&`N-2-Gk4a(h)lkp?MmKXH%(Hy zCHZ%G^o!JyuRV=DNm?P6{EC;`b^!qqpi0XbuiQzs_b7B|{aKD=7VZ)r=h0u~eUgId&5BH@! z?&tPB%$*;~znA>SQoHEad4&2rtr6-S?3-usb1QpL^kvj262uI*E7ZK7O~<8H|I>&4 z|L_?vt+-;jnKIQfc%8{|WLULitNp6wg#W~3-!rw7CzKDjDCv#!-KSY{)RC1*rjmV< z%M{z&Zgr}_L_t55~qh2*HYar{# zxv!3k=(qeaUiy3@){@3GNbg1S;zXIlIrgX@M#;{LmyPs39YDT(trN^TNHI#QW&gqO z4Kk7(--BMvp_*%u-kf#dApH_J>!`AsJXmO8GSRzn! z)L;!W*s0fyCGT;H3Qhkq&w8^4ZxTG|lgxdIXXNTEHO7&znB_t3#Tw3(SA^oyE8aGx~r;a30_Yw$oR}$*333V@$JJ0uxJMJHFe>kJ3Kq*c3-fOM-&iPE# z3Fqgk=rE)$eeR`nIKg>Df6hkq!tb-0zw+}vCsO|^9|Mnv(MYSr=L_$lt<*6dpVpxU zzyCi8^gfr=p;l>f8OJc65lBX?&dA;v_WD&|-nSmLmYW82n?ZKYegpRWHlXP_BT6Y! z&~i7qizf}3`G~zwBMtDsZ$yEI0S%jx={SWQ)y2pKh@vlQtGV**VC$hT|w_8?OBN z9#%YR%2@~3-M##N>e-xSSEuLs6aA3h?Gtftvc7I{J)$7 zjPjIt7qZh6yrc`WLUEjXzU^E`+E*i2e!Nl=;+fl9rjm;5eC6#xH+k}Jec2l9DJQgn za;QW@dHXgt-#O`3KTwDAeu?}GM8uG=7)aE z zEKdrI1roSKf%OgZ#I2S?x^~DHPtM=tYUfEYFNZv1-aopF6L!7Im*f@&Vn3{bhbq58dfo>_DC)v++}x@Xxjj$F2wA&~E3PoaCN>^7Bbw(lbsw_#uhQG-#;@m}yGrKKKTkPF*ha6^BeEl|G6Ty$U%=0$l`~`Z z=}dg{&qVCA40;bU5J2zb$jTXb_L&_evD9-qn{l7ITBSYwyJP5kJZpw|12cZ~Kh+*& zL)VAY`JUTwmgoFQEA2Q$w!zP9cC5H*LtHts7m9GEbIA^U4)rUw9Xh2Qqt4LJSUd-# z$C4rUjQO)(Ir#RNU(<?cE+u{+zEp5dMKr1L*sQoL7?e5<6A_i8us zt>q)%_5L#Bi@!{o9w_mRJS6xYy}};8()U$>#EobmBMy?upjAo!R3GW!>LI=}d?Y57 zx#UUiQoBfiO!oAZja7ZcLe^?*M|x1;A|K{@%B6i?a;!MB#q<_-slYz>Qwof#l`qz; zJh?S0k360{c|omFJ+MHY^v##pGk>J^JbwOEz8rh4Krwxu1h^N-)Y1j==xUyf>+g&q z-ef&>qKD*?f>~0Bm`^!mvr571jlM|gIjfc{FgG?|;^>KNUx_@%GRYQdFkI1+7pTDo6Z_3RXmBi7L+`y7z4p_8 zm`ML3d)gPz2}j#G8r0gXK}?GXJP4&0xGW4u$AshiIt^~E4#$kb&Od^ATV|QPsI&6S{zk)|vO?5osT+7*VwQFry$fadv8U`( zQ|YmgxWvQtPUHmGf5KXXjLA zOiky#lS{_qznM7B@7et?wV`~@s{T;pJw-O!olK~2u?N1k8R1UszgWfZ$6uSwHN$_G z4L9qP1$NCwz8v+fs?7cd*%7;g8S+x}FlssDx=($D8glS#8%ExwZ`fo*iIbdvWiao} z`=$C*cD;YGV{cFnoJ{09PPE~3v>jK-MR}6Xx#o82>by^jWY{qHBsIwoHdt!g(U^M6 z_x-$=`L%(<8SE3ysNO$+T4OCCF7@Ep{|D6wUD?mWZJhRw{Q zF)LN;`F>ecja-uz?78Bed{U!CncOBtV#(1M%=utypH$IUlVwO5qr47grY@Otx@(D2 zu1>Oi3m}WJOrjW=b-YCOw_mvg2`y!mdq|R>O_i8(*B9C;%!2k*BIZ4{0~OhdJIK<` z_d%U}&W0Yahmze3Pk6p*)Lx0nhm~+y#xry(bF^oenboLJ`Kk(?Dv+r(%nwhl`r^<= zC02A|mZl3kKDRR87pOv#54)(_G4pjtiGJ1Sot(tH~3A;Ov5#g9DCj@KdbP85pw;8~`U4l$lOyeP!k zRY)|_$${@QpL@LK6&+_0n^Njqwb`58gemeA8z`bP&9eKX< zkWw%Y9(_5#=oQ*^--1pHxySrq zLA5w~8)N8?9Av?+a#l<}VZo}m79>);nzYM;m0hgx&~e{M%^~Z#1snGMKR@Fza<@yZ z36Qlr{N!VyK$*3+k$fAi zvWmXJ!YE)#iLa`iaJ z-|&<7eGB&3f#MX{Sb~^a2;JFO-iHT> zn~O@C_ap;x5j`M{%vc%BpNHDKDbF{f)Owo$Mnw;yFV&Ib2(_xepzq$A)$p z=s$?uuM3&*pw|AgtC<{xOcWZ!jLJ4U4#t0gzGM!%3?%!@jqBAqA6bx7UtB->NKG)PEu@&~D-7Ju)DlJnSqG}#aO70e6AF$W#W zKFkU_Xn3aX|D9*w+4*=*NBW1 z>e(}_cs?W>HQtgZ`;|SJ8a}H+$-2s5kSJC_6&928zsj@9Q zRjf(L;;v7YzmX}@mHx%@lbElhrvJJP*R5yls~GK%+dJs@Y)>zvf_eJN)CcItSp1P1 z!6A0%oHMe|)rcw6>BVTtUgf|P%op|$WpQ@Uls{82pS>IC>uznu*hTcCggdDxlKs`2 zy~=88mi6XS&om~Z}B)RC4BH9eUC=X74*%}KVzFp76R9~0Gadzu;A`eX0G}E4Cd>zmip|bB?`4ab>qfoQ)R+! zqb#O=HKQnVzB$Zw#2ICGGe0=unV-EtpUgca28a6NV=wAf*-?1YDH`qm<(hwyj4SGk zE<>rQdZb`y33@%Pe2=U~{NB&kDv~*as@eD&OCP@73TOJ7@_&=L#r5)0HD1H}6l!12 zwqEhQ+G)1rVrxzy9lDGuYh)t1cK zPs|}k>hYv5dlTF<5i%+hp6BW7P9(3E-s+m%&$s7Vabj-{CRo_*{Lzj*>+SFv$@NU< zCz_58rS%4K5hDVmDf=WV-w%>u(ezYSD3B9F74RKImhLTzA%E>{+f^oRK!*v$5nz=DHeEOISg!FvyUfa|V}hn8|}+4`pB`e)6?x z%KiN3mF$^5%U`cE%2_S0(FkcHWn) z$Q1TZ*HBK8aqVL6vzSK&PBe`q?~Yw`^VuO4xyL&CUU)96F)bbux%8XH zbA6{)kyv2Hg1*dpEvJ8w=lm%HayXyh+TPucDkbP0;2GxNDSuhEzmb?M9`ZSd+{!gU zVj4^DPrL%>emdc*8$I|F6&O*{8P(`RwN}<(Tcid)!^2UwcqIPat;O}b)NuH^1U`vH z<5l#Abf;D`HxA`$==olm;Y8-p9=O{^-AQ)@VDiKVBp6d8mSjS|e+^?+<84)ye-c0gY3 zKqV&d+33HC8Tx+YMa-nXdz}t9j_6?KUfuSd>%|}=)cz?LzSD?7Cz%PN)*9c+2>VO& z2iIEBEQEbEMXcEQgnQ&^*?3N--r)=EQ;r}9@u)%_m_jb%5rw+NQ?8#EIs2@zPr4;1 z$(L(9e`Oe@{Apht-l{~ozRU^GN7%E13a_U4;Y%SMylgsl?dTA9oZiYD9dw8IoDOAI z&nou9o#jmOh7nz<`v$9+W#Y4W0iQv|>0|u&Dt&v;$w}w_dc}6~^|BRe=gsuw)5my< zGv3ksdGI1dMv%Gxl^l>h9m)QSPLXT$S!NChK%cVoFFy9ghu>VgnyWBzl`lGZGRxIf zhXcR(njFyKrAddRCDg%dr6Po0#_PE}YrNzQ!L{>4`c^}%$7`bryxdhJAJ7Iy8IM?7!NIk#V)j5o@!I{W4PkyL56%@2<> zO8C%c>31jq8`k?{vx9R3u2;{!Vz6jt6m~X^!4mF0s<(=Px)5jXZd|*leLJY1H{!YG zKORTVDCPmUhN@Rmvz}-{=~(tS`dE?Tt5AQ`E7UzWyL4TkP%q>D<7X0imU9f^5wu^P zk>4beEKl6XI_A&wG{+BqyU9to!VUp{KLoT?!8urkvi~rv@Gc6k=0!vIhU@!A9q)5` z3D?m}xyXoX)5!WMYNU6H8M7P%44fZM%VHPOTq}B0BVXxaWtSNL>*b^_NK>e{^x&+D zKbP!QsQYXoKZ!ZQEm!u*_|J**fY;6iW)Ej}OqOG_=wTi}~V0f0N>RERN~v(^<{_ z)}wB6x+XjC7li$f|E0wVa_(};NwmAkl|Zg1{^4lZlfL&s={Pyl1_eJJ!ToKI6=gId?{8Zsz*Qz?b>5`xi>^zEq}fXk{^K*7NC)n_|PfV?NUFa=v(d4?}*3 zSUi88fhu?2!#KcKJZn-%+(G@^v;lqVlRL(Jy645(a~1{qFv0>FJKRB!+O%Qaju-75Qa;p zSZaJcZ|<{^o#DdXbp;;XV~_TWI6O;ZKQ-86n@unO-8>1&3Bx-2zjQ8UoZw#FIm|~A zsi7X=^SpYESRAjJfd&0-SVX^7ZpI(^{-qc4O2y&>^|f9D$UPk6E^on5|w6CBTVzQed!T=XDc&zJA}VHaub#7?i}?7KoNHf^Ub zEX#)Pzq}~Si|9%ubu+0ZB)>71u%qcf2E)`qqIo)UOHUsi3PpN_BFCuT^l zo&n(O^~Qu;5smTG1=w#K6G>I@t? zZ^LqOC(D<~mjaJ)tfkLRj%J{tjoR#SSIMFd63Kn+(HF7!Iwk{|-}vw4+~8f~d>PB< zM#9oqc%I9^_BwWS^{69ty?C8$WS1E4Bkyq;Xi}N`p!2>GfB28Y_S7<)t4GcC8RXB} zvC>*sR#g8hXHvt^gV$~Q68!n8i>#aHA#0B~(VNCT>v4SF$I+*m#M#WMdh*Ud{vhw) z1DVXc9LwO@*3KMQU9l!R z6zWxJ)*#F+uP4=$MmFK^DVOXm; z1P{zWwNf_Z@ZUR}zVE)g9=e{|Kz3gS`gHh@=k6wR{uW5Nd0}w#j)U=31{x*vv zSC;~b{Lu^5ij#kO(~NIJ>e<$O8Rvcn^{fCw&KeU;v93)rqde<=A_aJ|^H+iN$^i3ad zkzRfUlA;d7>PNAdb07oHH!~NS;wh86A=*~ zL}|$V(bVOf?Uyj%DnFiZ+<`-G|K%R2H@oYw;T*Ydoh)eYPM+6+WGV5R`<2V|@r^TJ z7`4$m=N)LqT-`}>&35s8853&2Dqs54m{I&tZjWqytitBHI_3)K58~c(lBWZ+WA@02 z!OYvGMkB_FS^>4vsv{KYX)f&1*y@e*g}6VQmW!yV>D22M+%tYz())!-ka^Iz)PvMpYq2wpp2a})JR)rb-cU^zO9_l4l zY@f$HXnW2YzWR{s7fpN;^De3M2T;p67`IpaN~)l{&3RH~!L*JY_NzNtu;=3XWIYY?};OpO=`hs^2`m=s2@w+t{S@b4Fa;SfcqsXR76+C^?Uis(A2g*dRi|w-!X{-Qzc;_WMUqrnNPi6bnk%(p zr_y)wH&3yjIzLh3&eI21Ga71@0dJ~XFoZfn)ka2U!F@6E#XMZ_p{90~J~ir7Wtt?* z`KmscyC(|e1{h$f#`k?PyE9Jgk%#T60j-XP|J7t%UPxWPIJxosITye4MT-$pSl^cK z`wI(d^mE|&0QPTvWv7+rJS^w?zSGHqe+JR-c5{#H`bDA|mG7E$Fem!s^pRtk(R&O19S`27; zJPY%?E7X=6MsfM3L>~=%t>{y^H6#n)8!Oa{&L@fGy%PI*CbPDrU#uv7$MpZsPu?Rz zHGQz%MTc1GR;`!O7kN>kzWUQ3W4*{vTgncUk9=SLdp$=nYrAN-#8o5Lg7cO(2iebV z&qBFP}XY<&0M3zsm?-7G#mj znVGOhJeBM|`zH$dI}P~JfHRzS3U$mhdb(zi6*7qV>)vGl^ZBrr`K1@^i~l*E{K^~i zu#)=e)d+T?K%tHpWt66`d{LC=oie`c89$PRv|c6zAH!p7}h{^Ez+L`OgHC151`A$v}FQ@R-}w6U1^JEiAbAB?6idr>*&zk}F|V&`*gS%TD}ANe4!^Q-{+RkN968nip zU8{y*Q17&aDuvVgIBzpmS=K6T$IE7?4^QkI(qMqr)Um94df0`akZQ~Jnc`oqO=}eL z#uT+?cgVa0<ZPcC+SVQ&n`$eS(=*iE1WPbZvD+vTU)}kxmk3} z27c>J?-~?04fQMED$LqC-RF6c^zq$Zn)aUgVw(47uQ*jT%I0>7@`Rm7Jqo4BM}LEy zy`CsPwj0F3KEXpN3|)-{Zuy)P2_QJu&Q+ zF2C7V{V7=vv@%FmQ~tluD>=X@dm5yQsbrEQ3`vs2Hp%jgQE+l{hkh*J&bshf#hgtW?44x)T1!lu&ZLI^^SrV6t-ta&Fyt zDm$W$N)+wO{`Sf$oLxtjfH!lie4d}-v+sbPl3XZuqbsRFKl4TBPfF}o`{LYvB@89` zY(K5UW1i{9^Y17d${vrq%y!P=Oxjh4t`Rz<^IH4yD~b$oYDC|n(S*LlhwaJIxf_kT z-FW|AB8!JU#Us7B=I*4ww`nvoI?^Y;Lx-%_)U`L0F>Q^;_&YI3aPWHOvu|{R7)+Q< z?cKuX6g|FSBXoH5g!jOl82mk`L$Dj!kiOCIeZbBK-ZOqr=xOiBOf9eZliQgiO`tb= zz5#{3jF=H)K&jbAOf5!6LnksDnljT#c0|ty)MGN4$DL$kM;K?!Ey-}4$~pHeBPKD! zQM{HBu4XcaFVG{|jvmEjoK3%Ek3?PeYYc<~nLwFza0wroHAGGRz9^MeGMWY{9-#R-C`f`8u zD7=w9DaR}rwloV(66t4jq7SNzw+xNgV-f~(L-+d z`%2z#cQKr*CrhkK@jUE7t;tL5qo~DqttXkSJ*C1)ABp#@E0s_C%B{BaQdL(8X1L3V zRQj==`pBk-?9H{)w^&e5hGqLn)Gl}VSXL=JyLm~4a9o86sX|ugn86kT*zsxQ<>-BCS(OvWXG*ff!Mk#Fl`@MK~M9g$hAD_ z|4@OXSqiAu7f9>Q`I51m9>;u#N$i-Vkx^gc>{V{v-8x{@IfM@HO!4H}#X$EN^xF3hI> zU6WeLP%Yl1vA4QMIM&zEvbRjjjsXqE6(J{a7W1WQb_2C%|Hd3WUgVJrUrCSU)MHjZ zBxk5Ny^C?NSg|4w(>d?hRGqV5S3QQF(qmmmc1h3R?>RH?NncfLV?CB~?$GQTJ4Bkq zVaDwLyjkqs$Y6KXXzB|M^k}nz{YdNMV7||D*aR|h9>R%$mQW7!bP+a`tjAe=68}sm8;a3Sv0^^;5qc|H?Wx za6F8ij}~?`OtrJ;nC$nk2 z50FdL1Ebdj%EYHiNxWTCmX-67uH);;p_fK94K#!`pbFpn5wSw62l~K`C6Ck#&>(66gN-4oL`QQvl^ zuhB{m@<9bGYn%`;wtfiAz;d9zxJTgSq2 zX;L`wh-dg^)H_>~!MKjy(80VnYisdidj!TRG^kOX^F7{cTa{#Rz1INK!%^*#7DqPF zPt1EN^(1*K55n;;H9KV|etc6Tp5N8r{{NnBaY#5Bi@ec# z99Tvjc>#Y<9jPnt-<`YocXa1mYZQILQ}j4oo!-b-_8kJ)%eTZl2E!@O=Ba}R_VRoFP{`G~LR=Zg0rJ&c5_d$azoRjin zddi7kZ>5G;%Z~h}oYS?YKZ*Cy9=&#hzTp|R|M3sEZD$Q0T){u&d(RK2Tbx@J((L)ekWNE> znq0qTnkI z*|=-^oiCZDmkX<=p9pp{O&{$M@}x|Da9G8CY1`e>Os!rYF~t|ZmiG16YSXcOqtiBO zZkqnN**twl-OncNl+C8dDF;J3S7>h1RoyF%uO`a^za&YWoGPn!8RX#PBq_TtNlY#1 zQ{0~*#ix-~w32;jedrPCZCS*a2lX_Vj9Q)ST91gW&1U*9@OGD`221%FbcWhnm}yD}9b{mAJl_Gs7l2oZ)`YzJpo866{L|V1~t0hbA|5_+g9Y^EL|hV>+mk zxEEYWFXKZU8hOW{RCUfkgLRnQl=Ho@^g$LxVeCO>Tc+!f5v9ZGU1T*Dis2lXXYl4a zoaRi)dXe1jV)QN!kH)r}(U`Y03YG#L{ZY(cF4y5>4%uO^$>G0az^!2RM9*NB?_UG9 zIQaVrBMy!-;@B@E#+4vIk@wi~ zyi=!?BgxzkHgJeHSp>~XDlnY;!lbbZ$S^H@`h?@+33}c4Yf*C|y(%O4^KdV7;T3ti zd`_SBiN~{xtW$~vXirbx=J%UuQDsNrFe9RI2DF zOWp*@^kFL2+6Bt83kqCaKxSlJXWVE}2z9zSqa?2>oYvy8J`%luYY;&%hO$*8bgv?z zxspWy&?bGlDaB_2`_k|ktroklJ2M0Dk?Uw* z&Q#l&k#Ot`zWU~11^1e-Ds!K@CGt}T`QafW=zvmJDJwuWAZBJ}EA z&|&vu`c;xs5HgfZ+m`Gv;B)aXpPAn$q@d1J`Yq@InbSBMk={HH`|;=E*)*h~lRCbZ zliFFUP{+QcZ*MNO(x(o*TxFEzO_<-DwNLB=66D>+6lt(vpA2^Q$Bgg3C>Tr~f?km8 zZTv9yT>zHTYcZyx4l{pKS6su)@3KUIPtYu`O^>Mhf@=*=#Q$3rY1Vf&!&&iLa%+r7<6MkveQ=s z^gi^VE->K3Z6hMMCcNb{c`DhA8x1_8`(&eOC$h=5a8^;=Nj=S?P_NgsuaiE9u>+Z5 zR#8`fOF!&ldN8ah^3{Kz6n@P8Kpgu+W^k>p?}veZ{V<6?k2kgPoDF`sRVoInE5%@2 z{TN)X6T>`e3~o%1L3jFhZkvpl!}rYN3waE|WD#6W!RDIx(7n19vXUIK(e%#0wqW2Y zE1v9UA2&U)F4XpiQrC9xr%-#5ljg`smA~gxWLaveq*qRn1;?4!ZImphI;qf(np4dm zHOX^pz{Iy;%&36=f&*&KN{jHUKJoL9TDWX z(J$D5d;L?~v!}8r;h-KfGwI2n!M$;7a$#p@!btz%2DeO1{%oeNnLNgx}ph%q@9OVAG<82?Q>Q-0&_VN?;aepzm2FZ+#O8Iot z32o0R;MYol_He@Aw$AVm>=$=hh&MtO6=Ld*; zYgcKI87LuJ8cN-4FR9ltK%5Rc;mZVv#CtiT)kkMEpjWS&pEGJ+3`ayFnfq1^D$da0 zPbm8_m^EF+nS0B@ahUv@XEVM=gScKKj-_^ykco%C&3N4|6DP^8%w-mH%Xc%B3vy6U zEC-voRuu1NN5pNO<@4E(Sk*_4Uh|QG>x1Mbxt)Kls{kt%%Pd7l(VGmgDJ3*kZ^JTy%EiO7VnD`?S_u{o!oT-K5JeiH$`?y-D z?abFBwGp$d;ap3X>QSvJ*_9W`tU64e%5r8+$J3WTmwD2wHq;DaZjIjDgO_sf@}3<| zVPrzbr^>oVDdI+6#!hVVOva5KCOx(OrV)*)0W#9EvfBGvMsE~Pty>(=$oN^6> z>JjIchq;cn=If-OX0MEakD0yPeq2k-q+k)xKtoR$kxT!%d$kkN?J%1Z>e76jZm_$cYK2rOvM@#N`_o%ln7xieQ^ia# z!?buMUI(dQxXJ%jxHQ8BoyWfyki6ny8}Riz_Ynt!SD zXVcsGl=H3&T({I#*xa+Z?vj18$BN?IZ=7%Hqz)ZJZVRs?U#{zKxYn2L>!d#VIa#a+ z={>#4b(B9-s}4q4M|M(6oj;D=RwAOiKj*W4P{yd}Kc`1FTE|XevK0nJBhQVm%VHhQ z^F3^yV}v{R8{Ii`2wu&3Yd{J{^P0Zh&dRwjJ)WM~Sg&R$Wd9yy&2cm|LbQQQQ2RH*Hw^l#6D%_dVG$sKl;pj?C9h!RYw%ar)e5Iz05w- zml^o+o4O|R&a>EeT@Ug7hWcpFqb_>i#6!6CKiL+ zQ=g@ut2=pivt0`00{tveK6;EfpMltKZG6~C2vvS^%!oO`Ydfz0dj`8McZH>pRC z;rZY6WAf)LMLqXM8EQPQUFFo}T&eBEY;!idPq=PWiMQcl(Yo>`@voG=K;8Wj`()?v zSy#(`cZJzUmHbB@Um;I$QXFceXJAt`8=kImm$FR?V*$m_w(!Fh#)Wju(`u#b2% zwY6P5Z!&K%Z)g}E{bp}(@l324L}vd!Z@E;QJhjeYP+g40ITL+nVAiaOr)08Mx9H5C zuz2(Q)Py|5Z_HSnR*E$-SJH}vBWF-79>&stx7dc(PdKYNn=kLm(m%ML8fYgoO8VMx zt`+;cZvB-7^sx@##7Uzw)bF-hqy&D+b&w{WEP{rI*)K#5`M0m08bSshQ{TMa+FN$M$P@p{WK{6)ozN}=&6$CyF-0j0Coor;%wFbK zu~<~b4DIIk*fpS@d?(-V%#$z_s>Zcw6l-f zU)(no$X+e|bVXuOD1tflIrQ@;(eXx17GVB$e1(lhb;Me#V8o9v*Q|+S7(%5#Hi2`ErSSNRRKa2vwUg;Ue|p;(_8m zJXc=Fy0Uz_uoPe*;F_mg}H;`6XsP%KV3 zGO)_QUZ1w^vW?t^V)0?HD*NG+Yob=eags}HiyHpdoFw4%bT&n&xR3v9gfs1 zkiwkL9k0*Mvv>3l{vg+KjhEE+;GXN?Ww!OoM9h5XH&=WYRcVJ`7&n}eW0;%=vjjq zVEQ@($-O{1CwTBW@5BA=?_C*)3gs-Ss-N_vUvft|Em}nI-!;X|t_d4@>*~m~?+VU2 zH2BAj*P)H`fm77nJ9$Vgvf;;5+sL0lK5tX{$`jZ>w#8lS*O-k7WZ&F{Sd4qk><#bV zHOX#LznX$PNM2WsI9sg7=PGsl`E5L9qbgS}chw@jv>uDUvk$$r9lw_tWrY)cQum{9 zhv&;?n=RA}=%1RKBwUh=g52cVe_%1S-P~l%ZbRLYzOAO^ zj1s+&+DH-h8aFj!%>e45-yEoOB2iX)vpe#AG(v79qgw>ehw%<(fD`4z1r_cxk8%2K zGR8$&;6iO-gTo;AnI);_L$APM10pLh>rg_Ww(99)s-i+wRTL)AHo{xUK5ObDl?$iJ zS`YeVF&b2-V5r8&OX?5V@f>B;zhioUJN3ia-@3G$&neT6M~-XF=l zJoiJt`SsJM8l`1>AN=a9!~MqeC3WZAKAwBng?r@ZH1fg@%){lNP^eRSCCYK`Q><(0r8vUg zVQ2pQ%xuK=OOgxZ=(XePTv$u*0=45hJIFLoNS36H^o0!4VM{&cbt;lWM_=CBrz!HB zvx1r)QMk4u8E?O2!Dlo3J2vc*xB~jo>gzBk$%xRxWG}hVk69-{rZn?Lb?)iQj58vp zFZtXF4h&7&E&ly{aI#Sp>YicdWH?z&l@#iPA_n<;*@v?w`VH^${h~HqJDGjNFh~OP zyH}6QL%B9aJYP#6-)QT9oiN*Vs;Sw zXL%;jkOj7PJAEyUqVX}3Sz5l2pOgyqo}68xDyqaH?yrOS`hQtKZ^S1D)`#sCiSxmZ zkJQwb8{itlp5L;}X>vC6v$hgzzDMC+9<_Q6b@R96=xGvVO}HPNsaYI3#F;^3awmD6 z6ep{G+;k-ZUy;>aiZh1k7Cch$dgx=6o}h--jXcfjWE@c6@9?VteM_>Ji~h0#8)p~p zMhrh?A@@k3E=HeEZf_qPeM#RLIen#^$d~L(&4;s|TI2?%X6dkoGYjLCEbO3PZ<9S) zuJ=}9Ri|iFh&Lc`D*dYb`VI#AG{4a2+n>E0kGLltl7*N_4rG!$ndHpQl@HN)zJdO` zUs>2s|LM}mB*GBVeZze%63a%F;Cj8r1FoDRQC2K4N2 zfvPTjWcA2@bWvgSa-Mb0GaqHP;3+@8xln?5X;s+%G79axFei@!I{#}zSt0$$K_~j;dRw>5n1l-=!Z2W%9xqtB(g8N%nt*ub+VvuF=m`k?v{&#l{grw zLyKw#Wa_g}jJ`!(6lZ$%__|%=(gU;ikQKK+@%BQn1mDh94qY2`7%m;(}MxobW`m8M$TR3Iu?q0A|FqStJDxhRCVa2`fK=8ks`R9muFn*OUqDtWAlW$BsXd8-$n+lMbC zN&x-5$xY}18*0GB;QusVYMJAc&NU;W@pwLci$U~9@xCz5O_0(b z*#jOLg@)~nID5l_W+N2p!LGcIW_qKcL5HKO$zu(rAM2b0lMfkWYc6}wheadk4Y{|4 zt!P#Mf6rn6KYqp=mUX6ywKkaUeA$s!pkCE-SIdzGzy~ zrg!?TLW9%q1U@jO81A;b(`cosO5*_2$F&1Z-y}Bp%%jff(ZTgiWu^{KUtd2dWYCRq zCR4jEruwnGAIL@gGBQafJU=L(dl+OvcCsA)nkWyirpTs+336!TJ}Gcck~K})@x3lt zf*S0X)$}z#p1Vf^bIH;fW0aztOYdHmC`niM%CLyNQg%U-RKB}MUY+3gTaqMWrzA_* zd1?*RJYH5zl%Kl|VjXOda}AQjXU0CM#_Zy9FN1WCpaSo#AAMst$a@OXC}azTn3)&pD*&m@fk|wt@XuR&uA!@ zM&mm*p_WIZQAJCCxsU*E?%ya(8Bd-f*YvxiqHvL3SS>Xq zU9A`_YZQa=L&;Vc5zUSS<{iU1_tw+%C|qYak8WNq2LJNc%G2gi(`E0)U>&=obhy}& z8P+_qSeKDUynr+9$DHr1pf5a=p6E~P|7&HyMuib+oUg2%$LG)nBVKXdbDp#3JJhZm zTmu65@gAj8Q2qhu47p@Daz^xb2^rX25A~l7@R(*mXX-eMK<)(BhRwS;i}+x~l^I4X z9Zuh4X?6SL2#m~Yiu$e6UkbqV`JGWofN?8D-^dw-_|>swn9ev&NbQq*LwSm4I}kn1Qb z!hEe5*NI-ppINxZy~>?K%rQ5!;O!aS~zT3bC@_0yXvDI=B^*s+M`OaN-^mUg}HGRcexvtb9mvQS$Ul}sE zo}_jNU?-59l-$VvfXe|gj{OMJ)7-@rLC$>{cjl8C|uGW(Q6rVjfnf2dhcm`Y8ybgl%vD3GwX3cTE!FP~@SN~5Jt zxYwvait+QkBA7pAANAgH`7)xv6L$Y8peHj={1Wm-v&JDqiv5*)$MU5I&(rnn4jFcj zJrX53UtUuPqu7f(ZHN>5gz2v;>;$)Cxe_tL8I`*#@aCsOE^i9QYHBj?A8D~+l?J`n zhU3Q>`V76aX!ApZMu);MdVV+}cZK6KXVbF=hhq%SXzF4byxGDIK_B+hBLC)T5>B&%LFCphDj#kV}UW-HPz&OlIV?XpbYBK+w8-Fmv`6LeY>6eiKi}JvY?-cl)L+HkfHCwhI+Lf6O#jvPICMS4IZa_bPNXu^7@)^C ze$C_OWXvVRG4sOCrj2n}wOY@4I&*J@%}AT4$dlwDUs?Sm}2I&aKa zIx`ay;p_@oO&?YWGiBwO^*_g+ryTZgr1I;iM_ryyrVVwhfj#NZ>R=}4+YCEBSoN2Z zVc&$zxYC&jtz^b^&rBpNq3$#}6Q`-)JgvqVNzqJn>}bY;YBscWE40qYl zqZj!})JSfGk*B}Fh8|~aI9$?>#m9JVuSM2DU-E!AqKKy;sL9!gEZxrg8gQ9x&dDXIG!7%n( zhxth7I5!En*jP*sUzvZ`Uwj`1NQXu$DKtbWFVnoFprx18ozsx{1b0b$7$k>=QG0k$ zU0UVWWAB-}bR|P*(F~Q`Z|@@JsrBUGK_4k{xvmtM;wnz_>dD)C^`!mbda|*&mq;J_ z9KCsVc6f?1(noeI@f4%dM;cD@5Qk1B4{AE2REs=mb%@$fP^FKT?SySos{nE?f{72Ru&-4X-VvD;&} z!VGpNpkgaEGl1O;3@UaUrR*+dz)mE->wMnpy}p0I`vVt84h+NdJokO?z4i*~rpvwb zhh?lEl5_mAfc)N(oayao?~g6}1F-3U7Sk4KQM+v*4i3@c>pOpJi2n~8px5GdevaW> zYitk>G}0n#VgSbPX71OyAjA#{#IF@vbm70{RscSAXC~MSu61GoS>w2dUeOydBMiZt z$TMVLue|(Uz8rHj#zdeJ@f3%$Tn9@c{+Cl~oKIYE4?QiehT-Y{FeKHX-t;wjiQmHU zOh;~TyKu}L%v{W|5zvhxmbZraom|KLSCG3xET_%{dV~?XxzwJ%sCy$YsSJHr$)#*t zD+0wMIb$ORl(vjI>KPUs=UN!Eot&0Zskm1o6(OM(I6Y%_$Z&coM$kj-9`*Y9#BT0e zP;nsVtHd9dldrg^CMZbGPd*0M-5zpjJT6+$^$fMC?QHP5M8DD>e7>i0&bP$|-ziqy)=~?)!-hBCxgNOQ zIzF(XD3rb(oDD|RBo}Ep{YzblQ@*jG=}mrYr8i6wzjnq7zYgREb8S6P(65TT$5A%w zP}g(q>|_p055BG!*YgP*Iy|@GVhR3S>0BteRtwMC;PIx6*|NJwr_YH;I=S8{bKN<+pS9ST}#*GHoqgx zuf|U?Pc7FrDPl-(bJ3x4$tRlDN$x(Obn>w!wUaLwI3+JL9WoDibkRJmW!I!9lUMmD z4x!W8;oaL^t5ZF>akH8}@6%(=p?y}FI}h{i7}GC7(muyZhACcJwTcscKa(U6G05OS ziK3z=@LS_(xk-)QO!_(9I$)9w)eQ2hVXQdaG}1fOAc21wCGU$t3^{RfZ%4Gm)iFpY zJs$hV9+b)K%^E^xuek?B^Ezb<88V-bgV7+AE1tA1M@-p z)6m-`Ujyhbu<=gTt4aGn6F2jI@HOK%Q37rv*ex_FlZ|4xgFHD{4(P2 zJR{0ZWp86M!o^~O^DKVcpda^S>cf6A6W|^B9vLPe#)zlHPP({LmqyMek##~*6g!O)Q?AL;um)OdGkyY@r-yp5#n&|O>lFe{-rdrnLS4A{*{3# zYWCRdw`L7u{upb(T^-qbIZ%hPp7X%<)Txvr@6a@KlQ?YrU1(gik ze|U}$38v0rYYKjy;(oTD>%M$0B0rIXLHu_)*MIAOnHRO)U6wLyC?Z5HgT8x7@E{lI z6lpJ8IqTck$&OrE`f@K}PUp-LSny4O(PeoKybMB{z#!CXr^U-KE%{{34ffnlJwgO- z4x=}9GjbWTS>sF&$GNBUYI;sA{SS2$OXx$`Jq6#mhtB2xHpep;6|3bUNo-j1gtL@E z%oRIAew?d^So2-PEv$vy4EKyXb*?#1#m2haXW_vDZW19`Tl= z4qj5>iK{55Dy0!?kfb+u7*UIu_)l^y&ojGoN}(wG(UY+xXPAcq|L2pohu5fbPoCeb zNz1Olu==Ndgl^cf56T*?-(SkC~=_y4H$X=&ZEM(niS3eb(A9JS2XQynVTzqDo zmh+R|E36N1lmC&FrWQ||Qd}E)O3!qqDDBizubUl)k^^#MvmJK((NnWgv8)}d!2U=- zj9sFItpl}7*Xf1wJb-zSoZS=kC6LoiyHL9HE>>X zgxKLz<|@6(MDjL;rtqjjbC0tRlZA5^UwRLQ7h_~^qnsXhSW0e8kX^xv(xR_X5{Us{ z7)L+j|2P=&9vHGz4WAz>Og}=8_cjkA=#Ike57RhBC&iR9RDX$aX%XDJ=O3p8w7AMGn z8%BvsikF4&K6Ly|5!HYbQvOlt@Az(H__K^2?XD5j z7O7YL5Vx%CT^2^*&Ol}>Byo@4#QEmcaID`Nf&Jv5edO6S>JW8J<1EPZOo5rb z@~l^!iE46Da~;pqZ=B=)SG#v&9j|bcFEzd7Xd9lVEj=XjmW$lz<0wZ;70aN(3IwoU zJluzT#%I)GljFujuEJm8;)^9Bk+y=lie}Syj{qF zUy+It71>L0A6&G-La)6PEM^~bphO-*^T^kTrmwrR4KC~z{Je5ey&HA4KU+v*xVJnj zQpv0m_R^!2QcBlRU4V{D%s)b1ooa^3#8S^K#bn3#cH=9s8&@AhkVXgHwEBo zPihnPY)7zjIF_zpo+!`w`Q0L*CJqsJfIUwP`=jOb0IJChiB>%4|4^%Nl;>y`Gr`$| zRCmh7!!n!;A0gkpFExY3Zt|?Dmu&yrRs6{NoYt5=h|C)3`n8z4i4r&;Tr7G2eQlOM z9C`-vZ)dMLB8am_@(#*tajYN=qu;Ri+Z>KJsq7nn@GK=C!MHsY?G{}?M_!Xhw=9@= zfb;Pae2!Y@qE)S2Xrrjh3eDuocA9j~hkkh~G@qBzbJ)uyw`V6xJ^EJWKTeQ@-t_X_6eD4q z)!0#2jU;02p2K;zHuk{6vhJ8VmmKp6p`5Ale4newxaFbftO-TQ?09tENneqRMl|_q zz-u*i^2g~X&vT-SJ^AHBIlt$7dCxQc{2+cFsnFcwH9EpGBa-iDM^}Yr>2QUnkB32K zHcpgR)KUD?!64yXVkN%1QM^m2QS*=o`$IJ@g;Dz^?C0nM^PSv#Wf6O}DxoNHLDgP7sUp=h|*~(m(W51=r zLO+}#{=2`q1)Kk+-&q@#^q_CxmWRx5of{6_&=e@!+Tb|7sr=(yBt5^7uT&-s{ucHa z#4*E`G?bPj^X18QEjrc<$3>oT2+BbY^HtAwQ=qMvKMF5Vqq{MMIz9R`PHrj(cIQjV zZhw3U4ad;ZDcJtUirr!_6C;S(6aS8@_J8X3RR^tT?e8cqwF{+Yj34@Yhr?|J`wL=3 zE;;sM`A30uKK^(`o}iGI*SxhAE0;LQfVd*jt`5MM4LoCJr{MC@9D4jXh{|LKwVN;N ztT12!d3hD7tA(pf2r3Y_CjO{)in!ab3wXjhe8)6LX`#xO$~u2s{J0JGXIqf|h1k_0 zwUiGmkQ$f#5VR!>;V;Q=QrVFDjeNI@1v2@K9~8zgl-ZJkW4u0>u2G9XEx4ZghuDE( z7<-p|x0_aM$aR$IN6B~VOy1l-VHh@^xv?j6n8)5!irW@T{WL%HNejcpS{97EXT`fS zUefVLp=`1Q;4XP~?SCdSi;F&JHI(wFk^(_v>7Czzz6Gje%&KO?^Z*CR^7te6aqLeX zGsm`X3T!*Am~opt%9{CdGLU>LS7M2$lJRE%c}C^QKecC0PCj#@^AFRCZ8SGh)*07>kfTJAz^;>GM3_vq2wOpx;g9@*cq%#s>lLAfeChg-SJ0A0Sk{qB$F6Uo~R zO+gt2J@<1QW{xPsz}5rtrq0ne4e+C=U|-a5{_m(I4sixrF?|+x2DC zmI86!7(k9QpTme0G?-~cp4LsyZz+-i`~C2IAu}u z6F#4xaxi$EqjXGRcECk?WVdB6e2M(NSn6boU8UVn&a}uo8`LBmKIEO+X~p63Dk)Ws zzc(%bk$ag_+>AaI0n}b@Qp+7aZ*!*mVkh^3vU$n4nq@^jos)Q_{+3y3zQ{Wk1_#cE z{4SGs?Cm6PIg|LZ&liCfu50pnyFAN5P#u-5YfvQp>3ev;FboeDreHO%=e6Dra`1DJ zOlr?ertmP>meaS?9FoipA(pkCP2yFr+8L`keRcqOY>aq3???%0Tpju{KwZqR$X0P%2Noh~dfN}JFpW_O{WN4c))d9-G=t$eYdK|eWr2%265)`%fW&}SF9L! z!A(-Ae<{WK^|W0CR`I#gai7%sHD?}}g8pcJ*gY%E z^2F^jhERXw+e}^!{v|In1JI%;pR3LmJYH(WsM|*QKptOuUp@DK&dR4}pfziOT@HsN zk>`4ZiaL@^`l*qBWU0q9ko+d^no6t*(&5fY1G-PiK-?Yjk~SO?dkej_cLt*YvD)9~ zGvPl+q4~ZnN^W#xW+iiMm)&9>aYOQ--r(om}JH9j^ z3-7NNHNtJzC-D!R*~LFtT&p>P-wcZj+O>rnUI#Y1Wmf~_wLKUs6EB>Rw92V zjy$hpA@rs&Ag&MdtjUj?(mF;a2e{$FsSqd>tfh8mVA75v4DTE#gLW&?)tA?80c$>D zB_H^At-ELt|Hi8S`M%XYMqU_kf)Dc*nljYz%)G+9V2chrUm5`Nh7wr!eXK+;gkU#R zptgU^83R5{Brj=SF{YM}mHWqBQE^fT&i*oBR3QD!{=;F&IjQ_ciJMLIsD6=tXTcfx zR8))~H{ztjO!}Su2!=<0^2LfXuyz=0rvpa$o~|UnS%>kw{x>RT;rBnpa{4Don{i5H z#0F!^5+l~HW&KQkWd-U+_B?juEIF7Nea!9HM87BED<7Q=5`4fFxw;TsSWO=Q@(Tv&0bLdnL*V<_-9J|D7~EhQ8j59V6H5Kg03H?N zOp`cyK17LA+d`1@jd{&&Gti1WJCzIdF4^SR^y2&JORc3Bb+F{;J|G|H`Fv`n?gnG; zEFsMeXJP6wixB(NmuqX>@irsn{H-6LA<0J`M>R0 z*Pdn#+iC{+n+Gz`_6u{m1EZwO1to^n55Y3>=Bgjbz>Ryw$bL${$WKaCf2IH5^WTC# zi~(DV5iuuPRv%NM;I9675tTmt*V1vDA4A;|L|!$ZW(1$-a`bv2S)(P?o zml&mJwHtcw4@SEZMqE6ffioV=+$k3$8hX%qwx+k-A@Z!b-xjVcMt?Ou^6rwKs13$A z5Bh#`U)scdV@acU2|cGo@N*sZai5HxlnMLZ)SSJGmrFl5zxzi|Zw?by{>Z?H2gS(h z5hEG%nD6{y3El-#`@A3vYupu@SB;{$-rew}OE9Lok}uUR3%X0iX!s&d&JUpPVMWg8 z%Cm1=kb!^s^_$ey-S15=mF7Cm^Nc7lkoye#*7Eb?CA*_Lx(Bi!-^~8?B@9Iy|;%Q;4rjAw2&*YB3uJTG3mB7nVe)-3~CouRKTG0Lm-b{WN9Eo}`w@}j9N zb7Vddd##;37fwd1*uMm0Ux)!N!^w>bD@NO>SZVu>9JvE}lpRd`{1f?=-2eZZh5f(q z8AlyG*{R|9xQ@9mw)&*a+-)AY#kc*gykwudXR>^9mX-9WR;E(N`uUcmnbWFv+!kFk zSrO}uLYd!D5u7mFP{CH|yv-}z{D@wUi4Do; zCvL6UYmhKzKzq3wL}NC|raCc_#5r_HdNnF8$IG3;CZT7GgnA}Qh0HkS?Zir?W4sjj z()aQ?IjSq;Ww0_v()fJ3{)m&hwpjV1F^X$l@DqFd@M>3A)oa!^9es@#mTaP zhdJjl$@e<(Qr*cYFV4ryA&{$H+YK8lso?LchK)1nZ+Xm%5YCf%&J7(;55>lue~foS z<$EeDq&MT+5c(`CRZw%TJ$Z*3SGK4ybEFE__K~yL)*TL8__eqE*=24>oUFp~`YPP? zP+|U8H?(Z+&N-zTBRZ>bvomq&zACJ`s>DC%)tDtNXI^e9PgW9>K{p7HnW*iJ3!QqG#a zjp)ALhy&aoUxgTPi|hC75ze3Yo8TG348U0Ojn~r0q7}K1QPgxk<2wGyIrMN7{I2r* zJDO0pz6t+KU`}9bdcT(7dFf=tqA=!3ui}|%Pc5jCbCT7>-nSdE)gGciH&LWNuEXSqA%+k`)oA5 zm4%5n>D~CAKG>W+*W1SW>^aZIEA-aUF`uh+HqU`f9B)AX4TntJ9Y?-m{VW`zSHX;> z%&K}!oUJQsv3bm$f6Je(!mJj)P6h5$Ybww~IM_qlbaoa``jjl#!kbAc13el2U1ZNidj6BYHDH^QD6T7|SxdDfZBokhU{}do<0R82yGs2guJXL2 zQYsB8kp1KH<<3HKs-hJr+Qi)3ghKhzRe|N4eLlTN&XuPEmmL)-+kkw-@B(SS^pCVD zpysfQ0&)2YEUZ=_p0zlabXVZgUV7hwhxMFkI{XO01tb4GTg#fp zAFU$%(AnD$Z#@H0+szM4sM&hxOTN`R;@1ZH$hrHocVUhLd-heev>13^i;O$$NBS}= zSIz#l0(}=gYw>0=v89**jH>KUZFV5mc=+QbzxVh_Kg{-|r(skVlrZ+rw=_KLuV7wm}_(t9Y7ehnQWFg}qUjQt~!z9bxpe{l{& zt!r!I4R@%^SN9Ib5n>e`eCbUi8i1rrZdhDB)5u@=+#WMCvzm734;+zG$7E_0J zJQa0`kjXJI7^wk%G8rIiJt<%ydoTd?o71=Z3mh!~oT+4rgEWAC@jm$Ram7Wh?2 z#fHVnoTbq7@dY(#oJSnVO2GsE?xVGt+4PP63ZFT%F0|sYCwT_!Nq-K^Wlc$qXqi0J zNwrZg%o+Py8^+t)P@OZK?~(M2yF(AT4%Ca14={rK3FA|0|AvyI=wd@}eqZ5z`Z(s$ zt8sNM(l>BEzL;JT(d05{tyr8+4>`{4FW2YSb}_Gt|G)23&hkGHAKc<5am~~+d9}N| zCFWJKYco;Rc9#kM%z4=8EHlqJi}hz4S$kY9mzr^&wb5QoL!F5GxXZ+O&1La*2f26G zNdiZbL!9Cw-I6^d#6Ydqs-Jam*w4Dr1Di)N#l%T;wEP)O&;T{ zLbYrf>>{_Gs3knJxf~-0cog$PGTn+~1bK#P@)UzN+F|6)Vq$dE6`m}VM>~ltE~X|i zzF52l*r5sYJx+L#`$#Ti_?SO(rH&o$mgSuP5xI}Yi{;NRu2pg*-qDlsOrs+HtqSCB zDU`&?3hdfU%;>BFowM!mY=8pond6>FTyEOBVlj_UATiM&cTV|X(IkIl#B<$zBR;^j z;a5+KzzO8^9tgl=YL9DiP5AcnhkC6a_SFkO&{JPrObI~mj?BNAOATpc0R4ahP$@%; zUeN)l`N<#ks**4A(H}{-$RYNir-?u3H&*7~O!mjDk>nI}239`OA0v8jojQog@4``%xbW;e&P6{GSKJVe ziR41IzsYP5PyU{#%(fsddgK>zh7PUK(Qtj6*(W=T9v*}k<=V# zS}^Lk1*cA0@W8^1_GD(ey(j0lKfPHhlb^Vg++p%hHhf6IxrWqqt{~3UGzA-PTc8gi z$MG@O+-3_V5Wi@CGX-BcQ=3DLe_#N889S$<{aNa)dvcui?W_q(a-6?r=_(iiWuc6OP=ila#BY(^x2N!g5st}%Jd7fo1|7@JkjFo z>W4OON|1xE=$W|gu#8@2lCgQL<-1ewbw5EI#>Pn=`39B8M$4LR2D!GI`jqwtc}RWC z;cxNMqKQG$dld1$& z@|eEr&E1URH`|twVRUzgrhs2-qC)9nH69z3#8lm}Y>XPqB9+)OQH63<>G^b7 zg&VtA|F57nM$0@1)`w5Y=h#-BoW@bq-5#eW%N`Hr8IZRSsKaXJ25cwCWS4^aMe;kQ z@xR|_^jLRYhmgj4^uHgBP8XOVKu)8527Bi%^i!OzM+m=f3+uf#{NBI!lGmsW1swF~ zJV6I_0B2mbU_@*qw}7GI;rf>e^>>r!INpf;HI2ALEKlLg8nPm1 zZLA%Cw>LsJn>sdfR+5Q*C@W;)W-ZR&KwZnXOq`2hwx(}3UX$ZEH=g{K<jL$eeGIwcoM zw?V~nvb+Mly%accR*S=mK%@=T!ciHBTD(>}SnG|N9)Z%Ec_z$?_+JgSk9>^&ZajnP zrXqA#Dt>XVe_bsVr-<`^I%q-jZ}hC>K6sk-%gU=(^evqSFZvb8y`++}d{_Tf9eFK1dT1@>$ z50cyAc-gQVaBE;M%QJEU10~r`+k2Hjmdxs1pchy&FyKj5D7X8_zpC!X1@LtMQ8a=Hp4^4^9llgGh28esdpX zkKL6y)7eepVPpTfD2h3d{-*!s{=7Mz#W`yhUe~2R5&O-TEi>_ZDzgB_DKy@->@;bG z)VLFe&7Yvq98c#Ao#)G%>n4dU881g_8>LezlSD)%NCmSBE58yKdPDtUDK*w`kN>8*R1`|4rN8#1VMXFvS-J^dL^nJ|g_m;?P}ryOJ6 z{n0Fxuat!!_T1ANDKw*rqdS$g)6C{fzw#=Drud6O(|BUMn7+hIeVa*!li%-2eC2oB zqoS_pj%nNIyHKh*`z$qj>D8F>om$LnJ^KD3zu=P&F(r9@CXv6V)nn*c@<5IdKaDe? zXq5@;29Tq^llb~ka#DDG7Nk%=o}UTZ9OfZxra!KooyNB(uM08x4(ZgtGjlqTcz(<6 zhh<28a%G71e53Dj`Fr#yn|Vya$lY1Zv($rGPbHSC@E5U@o|oORF^4|Ft$9AR=UHS= z?*30b)_&9D=`x-ht~@Wu2Psq~;FgaG!#bJJ=mYr;R%T%LW-nimiQTWWP-Qc-p2)js zM$Scb-mgKY6q*;rP~&*d(mTb7$J%%q*uX>&R+IeMMt=Dqg!Kzb#2jQvl`aGqHk zZ|IA-(w+X4dR+D5tfN#Y5*(>vk09Q1i2Q#I^PGuUqm5tCdS*W;yXB=@6H8IM8Q~BJOd0qIqfr-x#{R!5# za}(-z=zoL$wX?Kn$v(dq=Z;BrBhawzcJy0BA6;uWXpbG$ha(I@FU_}Cu}HQXDYQR~Qg z`S_I)&^%|~Q;EG%TsUl#EHDxaNXuluVz59Rk%~N|U`>B!7caD-2G7*1{cu*(@Nk1c{Z0DX_1%B{EZ}f9mh~R_nchVFP!Orq*r7|))!@|;rN^U5T30I)>20? z(1JDW>25#dz4GDgI^2SdPpL~||5MgG7Zsv-ZalPM=YAW~chSGc+gXw!CJxe18>2o=_3*QX_u_^NVxT*cuax*8@W_ zn`hU~mZ8Y!xslW`6qQ0v=#$0Tcr!ihICuMZrU|PO`H@EbcM7r4;w-F7roV6mH9Uq) zEO?;MSPyak>uaY;;an%0GsYdW6q=AigR}`sko|@1!Dhru7pHhRev7lyInD8Xni^y4 zy5sE~cWkcVj$FPU9p_kA)`p^Ky-?;ogra&w^5LJ+^MmKtn`q*{tnK4IG2=Oby+W=L zA1{+%`H@*xpE-ALN`Ci7`qjRr&u~YDW^sS!UTsupN*<>_>{^B9{b0_ynC-l3xlvqV z$gsD{L*J4f6xaZO6?~% zfpev1bD0BBM~wuYU+X#FQne(9@iM)NI7c>ZqL%F#dr6)b?}o&aXHP$0-YfTA%uISo z{n+0;<4e#FvG;vEUd6d!KW2mLvT!ahi})1JhCI%t`JOuRxzX`nEx1L05eJhLEip*_ z21n$@TcgZ>mmoim)4Rv0!n!YN_;SutEmw_=JX4!K<2gS)6wj9H5xXW7ia0&$Gzvxi zGvwr_QX9}H9&2mH5XLM=a0nfOVUr@jyg7;q23o1n!(+9 zZbd0H0rZbNPCv{4+lOuM+E_mJ`6H%w2It`V(i_)2=`o&i2RcxyhM7;7;W9d7K{=YW^P=>XAzwariIM#}wl`isv zSa|ILT3oA3Zv3efjJ-`hS}8|4M}FCmTtB#!BVN2O1=G7&vDeZ}%6Fq*z-oWgSkB-3 zI2pq_Qu}?=Ri?iFDP0>AyY5B47|%od3dBV1n@IYFKk{L{KT6c0&ex8(?F1Xbt~$%R z%6$Li#xHKlv*S<-7W8Fb^R|)nI>@|WfBNoqW!>L{KFGv}yvWD#X8!5#e#~siB^F-N z!WrVGxR!hv9W-GXC==y!yaR8u%B8H~EYk=7zy32`v)$=f2eUh2ai)WS7)7bUo-QC)Av)Bs1stA#-WsQ_yFq73(S~ zrDXr#G9=v}p{MyA_DVtW8DfF0c%Av&x_E05dvzQ3RJ9=EfE5jgH4sO>{$5w+L{Fsu z^cv=sucZcK3Ui7E(cj`+0M^=v;n$uNbXKvxim?}6twO1$_eWTG7`Ah+5OT!|@0ZTf z;Y@+(ID_%{!+FPM`U&c+n0?npl9v3DMbG`PttD#%)=Fss8$vkt2tFF?>Kc zdQY_A>Nxs@c2&u^!cx zXIBer8=kM1oMdS5A6cGFUhoO>VZ+H6K0+Sxy1G)kOTL&^24Mf)FvR#;Q1U$UreC_s z?p5?RY|XsvN8$K5g*A=06*aaxib>Btwi)jWd+6>JSX&&=!O5FW5_h{$`WyU^et8=% zlw-YEgV%YtvwW%bhrS5DSotap>AzC2G?aN$L!BichBeP?=2MRf!}=A;xUI6{KIeF) ztp)P;H9s67rsG(XdDFs-t8I-%N593^6WA{|p|9%)GprHhlV&!Pbf-c&#`k%sCOtOz zcTE{+MM_Oa$?>NZ|l;nZ6#&As!*zmXr7z6ryo(dFT(xD{P#CFSj@k%4i~|FBFQ)ZRV;eh;5CvpfunAk4of0-})taspOR}p_j=Pd9N`G7iN{4Mxgb=cKVjye{|0<%9>Y$JbGlY*+m-Gd+U`Po-2 zeM`~XfwlkF#(Yl9IcUw{*z3apOfeW}Wvw;#+^3$mj73}^Wopun<{%$WPd8OSCJnnl=9s!TK4^`uaK z*Y`(-F5%dtOu?wSoCS<*BG#S-(wFnjLOv&3JX7&*a}H))s4x2aMe@%mE&ARKhpLMO zJFPibUp-cqhLG>pU5^+Yvuw&zZ%y9fla?mw74M3^L!2HZg(~9K z7xkDCYD66^{SY+@jh$<>+$OK^>kN1pNB^~>#h5)QR?dYIpBSSD(hUf+ke}5< zp?Q-YBhQFce#IrYo=9v9rEugER2$6JzX(CsmDsC3HxtkP(#oB?qM%MlECIp_39mvqIq5%Ydi*GLaIa&`hOYSipHVETE^t zg-i6U3m^xh8GDDj(Ng)F5=kd@*!tZ>4heHC8rkch0H7iPD$m3f;U%#Dp^v`l6->^FQaW&$k6tTRO3FODE zW5y?OFxBv4`ew(<%rz={XX~)vYQSIYCtfO;|LYPb#fM!v_h5!;Z~BM+PDimn^Mcz% zi_cE-@5qrUMXc|ynVIOVQfQjQ#K_dEZV0-fL*QWMhCWZnSl-8r4dO&QN)7)f%y;g{ zzn8e%@Poyebbxu~!&KNDt4HeqBNC3%_cNs!iOOh6;mqf34?gF^jF_-D17FzJ{6${p zg7M7Dj^Z4KzU&{*W@6hD@@?tGv3<5H=DL%QbB=zXnaox1RE#Sxd`I2fOB)XZ?JZ+LcXEXXeIVM2tl7nBQ|qAcA8Cp&rZ?eI@S%*`}MHvV?s;)nbc2GADqR!>Agx^Nz>t@miX5N?kA4L=zT9%1|Lvj z%;6CHv%v@tuHOT#$ZsvfbyPt#Z-u$c8#j3l~~m)bJ~mLCSxZJ&wfb&Bb;A0w|DsbD29 zTUTU20B1OE?G>6>-rq~zlz4PC1QU22jHj3@b4H=5Habp*9VQQv^RK@T7;&x==RIS{ zBW`69!*lYuRtMuwS0k=R(obz^F)^z+F|Jplc%csSi@ilOm}mTlx&KikcI zxB_Qkt(l=iesLf2aLb-n!o7hGn?D+0c*W=3iM^#)yo@}eM6>dI{;Lx+D?xpk#d614TT-RfUN7GMDiNs_bnm#uo zj67m@?w=D3)MYnu!(Zog^x!n0jY~F;9_Mq_I!-EushD}8!}JKg|F@aA^}HB^ro~8a zs}h~u^mtZ=yhZk(o&ognd|{Fh`ZEql=gd#RY@Q_<@FB04?V3Z7R-4?pgbix#!H2Nv@~1n@=u^NXks9m0WFQzIpcE3dtAUZkV5aE|u)q zq>1@P?{FFqGL*g$>+?Z2WE4Fipd4Gf=(;R`+ZCeYS@`*dHge0DqV|{o9|-9oqnY! z9vWrUwHOIl&U@J;R>p@K1)O2mq;JkY z=-->M!yu2Inxu7SgG?iT-;K{iwZ$gc{fzQ4){o7OY2fBRy`s)uB6| zq4lggMmw?gn8cr(9Ezi?6B4-xRjy23stY}J^62Tv+GjHN|2y?~25bt!!w`BMXvs@o z#%$}k{GKFosw4DxvY9x`zd9V?oV!hRYDn)8=lIJ6`|n0f_T}t?^XKwqO{g&0gmauN zk18^u%^oA}uQp=EN6t8Am@xLV36-Oa7+J=IWyI2I8;mG?ZA7zF?&)8R@V>&?bS>ih zZU4)VFd=|AyX`rD$0K6y+!yZdpyy*t`Yc-vnDUKTAe`ekZa2X^hg{002?*&$Uy2D? zu;kHa`yb*e#GHJ-@N5}O{^5D@3>BQAaBbcr9%LFyZ)(n#pCx9X`-cUXa<(Q3D-h(?Yduo9`?u-ZzuCPu0@qVl#Pm-AyiccalYJ zjxyzKQ;DA1OzJ#pCVkVJ%2;~J4cw)a#0qYbe853ErMpQ4xr)_Cc}ViyMpEYledy@f zKCuzAmFUwr`jLxFt*I8-&{95g_FFJhDHZ71U;P1pzpsijh60(wyuiXog>vUyp$u7C zD9(oq1QcLSPJvI< zUbU-Zhq2}W44F=^_TK^6`jh?$d;IAuq{VK>KwN$22a18QbPB!Q$iY(g^~dr%zSu;~ z+_##6aJflOcrWG$4C5@+jkwWaE$m~M8+}ZR9uET0u_b$+x4t+yo3H0X{ClYuuE_zY z8p14&7C~sJ;J=$Q=i#S6&l4>*O5lEXD2G8sC z0}3Xt{hRvRb@X~5URI$ZXT}=lQ&)+=+}-3nZVE>d`^Lx<#N>TAYyX>l@xWAMrdhCk zJ~g!isE;de!PFxbTv|Y^g#A$5Vqy`TV>Ae1wnA_!dNpC@263qc*Xco^qR$ZL8+Pq2 z=w2-q7oS+ryL>9<*yvI4ff~80#IHVB&~Oi5E1NTj4Dzh#A9w2}Ib5YvF@Ja}CT+Fg zb!&Rx7%kK++c3X}4M|IwxluM3AL57=jIp6!Q!7kesngA-*360j?;}0>Ij?v?tS+q` zb;HCUzH+YeVG^;3GW1}&YQ^W7tlnFy>H_Ixrjb*Lo)l+NiUe` za?Xm9Kbe(#(1!cH$YHFRixqqyNyPjwwsn$2J)C7OeWd)!Jv`B&g}f7IS$5b(PM3C; zzIn~$VUm;F)OyHZVi#Smx=1DOX41M0y-jo6WE1@x&o)=eIX`++^m3B9TyJl7GW#>m zN&akblLPnEa&MbbY(w2-<3N?TOi)S8V3jmK;zB)zr(`fU%zvt@crQ>%Qd~9X8hHyfDBH>BEbq_fRboZWBwSzV)m=0Mi1s*hH=3rq9G(hBI?wp_Vy0S_~EX zf9&IjgBIS~{4t#C?Pc`n;J#H zZ9RRi+LNcanmKhT%okh1JZa+2r%RCg*gXQ(Q;9uY41@U&v6{#9fNV zmIaoN^fA>iJFW_I8yfO+5q(ZpSx};t1*N!lQVZw<#r3qzkKEy8VrNCEs5hJ(W3G>Z zlZchJv!Ki0DR5YALH)g{C=q3Wdw*uue6wKN8@^6-D!d? zIoBjT9Os;8e#@j(lrvj#YBO=6w^rDkbMZQWv&cU-^6iOf4PlPwS#o{CIgdO-9*L6t zk=x8{iy`hk%8El-Jn$PDwI#VMWa(^qwfe3hTnE-&8PF1>Bi%NY^ox7%x* z6AH%qc)WbragSXS^Nh?-oq8q2`HZ;|Exn(|$il`k;@2r&X16g)9b=62YGaT}%$)9) z$T@$oL3*-(>Z^;BJ`G|dwca7|R7c6Fs|Kl1+9Y?{Qp*yZD7&$i z>$y{f7xW}qvPp&2iE2z&yJK=3`G(Zm?fsYiX=61Gu2kXc-^`7srlp&j^P2W*w2E}c zNcIzl`co@bxj9;XRw4V63ND=KSS>1SnWl!raL#oy$SWySvR7s%z(*x+^`y3@ggf@n zcE|2jD%AH^Bc(DmFr`EB@EzxLgUCnxOOMDhp~zL~;axWb+T$T;@rT-$F#4mg-#Iaq z{DyuZ zD)s0?o!>;(qyr8y&mxi-NCx{=_WBc9la`yJN2OBn7{)s9;Cmx%>Gb>GMhzr6Cc|0t zJwC>{+-=TQEk=yqKrI>Zt6#myW6U$4BmeDkjed@snT1h>wIA!eQ1UKzzoCY&hY42( z^5Z2l*zOxK^D@01`wl;(_<-_yP#d#h{{^(pkiqVG%hZyDGYlZotM zoWFgf2hG+D%wSD;#GZZGnoKy`i1U>ox3Os*UplU!`iR? zJaQHvXTqa;7TRy1r_EyeS+&c;(eK26`1$U9dZCfy)QdHsmytbj9%r%qzSy=u~8?jnqJ z?SR2<5avC0pU?X~f57_#AJpJ6m9!K{7;~5>tx=Fe9UNYZXEwee-;&i}M za?5*2z+#(3oMvAmg=fig1yU<1QD(dy^{zruAi*d(HxzcS=yN!OvC!uryu86$I%5>q zxL99xon`qBed zq??+^;Ter(MpQGoXZDh(6TGE4y_vEeE72w04l5OQ_-CI2mmJCN#VN4oWiZx$4McnH z^^<0V;Gdejwu8Y~uZ+cvpWKg2#vss#T28IWrwQXE#wn?dcs-%iXnf55_9k_%ZgQp~ zHXjb$-}cmchwsbY!AKqFw`9^<2Q`&p>!_;?FPU-JSDM_=%J)US;?Prxdi9j>twX)P z=?c8|Ag{NJ@upuW=9oe;`B?};9|q%wu|HnC3&C%54E>{HPSVE63*(Y;pip7cwj|73%AsCSN<(haDe^fDifBb&?9ah@_|mPXoF z^^&sZn@SGjfM%BzP){KbGDv~QTMCSr%d_3SB&shA!uHT0e6tHgRdPHTt3wgS>-lzr zj6-%T()+}q&-WN|O)+@4gZkg=EwJ>naMr+rBm62sCd6bjs;#FrZBuC>Wm-r!8a ztPu18=M#1ZA@42cid;gm{v?0*g=mbO!dU^H#g}-0?p=vSi!ckqQW#q@HnbZ-AJaM1 zKVVFHj{KtSCpp+&+nFMZ<4jT*c0m4kM-SogT1<`d#87f6`NPy0mEnnP z5gN``EyB|R&hCck(e9=mRaQmfq(P6G>#2jd)QAbsjrdqdJ=$HYX>OpG!GIhrS(63# z{W+K&mkrZR&iPf!!DF(NLwQYuKafcYQ|fM#$5>oVsq1>0T1|!VvVuIwIC2-24jmBh zEe7V5T8yp4bA{J(x~T^9mU!XGN>3EoQ|piS<;IOj=;yH)a$1jq0M-~jaAxtk2{reU zt88h)-(teDc}9f(q}JCp?s>`_?AgrxdTTbKUuR=*Tcz&u1hODx9(r|F{^yn1=o7WT zcs_rjCcxQt337RKvh1pzB15~R$o6-h*gS(8Qm@E4T-BiYA}zwpdSZjG9^v$qXx&2( z*9m&G9KHw{^XZSt>lmHF&n$y_h^MI2IN1o(8=fT*S$H>!dA%34n>KPUubzXcm9o+Q z0==ZjIehbD4~X@(J*+A2??*ib&Z$ovmn6G4a-LyYlC&R~B4vCNWPiLGsyG!CBQ@m9 zHF!Op_bHVgup{)CwS~MVYcvx!M_|Sw@`JM?K|&W>Ss(v!!Gr;Hvg#5ogkNTCY&6PiayiF$TWs>K6@w`kZFmscf3(*)uM;! z)?|5I$0V+uGORwBcS8;DES$k zsG5uwe2)IAU__XU5vwQWpi3t8$1Y~W$j`282G74q)VtbCZN}{i-5k9_H|w!NclJHK zc*5xa6xmn?P4g1_1|Bj>p^>Sj8q0taYALshXG3E<^sS&o?S(uyZjyg@Q&N{U7-ii< z(Bo1d?$`yR!Kz@?R)%m6kh*%KV=!$@45DhsV8#J@{pC<+cuWR7>yfAKZ^qY?^e{d} z?b`Ylgr20Ho>M+jr{`m=*$TB|KEjzxzFnf0q*fY9FX1k+={{2RsYaIlY$dieb|`mN ziCM=uClG9h;tqCjGBWRC4s^>D0%zt!E>o#x)IJzDFNUI8{aEzC2;Cm2vm=#5qT&GL)=2pbvS3i z9tGjnr5H536ph<=c&=CAoWd`1mdvG2f23a6AG{xBGw_jTeD!4N$-9tm{KJaQF8S2+ z&PQ458tprqk6yd;G3b`JB=2;Q119AlZ zogKD44#ted!Dv)S_Wkc*L#1u~(Ts<& z^ml%nj^N2=>f@NPowESTujk`5&oTdZWb$WP;mEu`(cVq8E!0xM%T>;CCbxO6x4i47 zm6OwKve28J1aXD(d!zz)mhg;kt-z_-!HD}DjLKvgOI`@Z?1Ug{jf5bVx#Eqn)aoC= zdC_z1^E$GI@{Bx17WFiXEYz5w{xb8m5WN{)3+Ovtp6AvA&Ph(>JO_0VO+I5!v@+U`-rQ%r?5u~T4kO{H&$@I!F(PNe8Mmpo;MMku3PmZy4 z4zASB#^F`jD4xN2pS#p6Cx=#_ymI67)I_{S4t_Pgv3QnUS$jaTQ<5e0szFu`CVSp4 zS={odB|r_4jos8Re$pazmj=PPS~&7NwOr9-rVH!R+@JUHdTNZLwjTFqAs^>+n`hV@ zBgT;({2os49WvI7o8+L!$t*lOl8w#W4>$ZGyBE(Go7dB&u2LsO3SGNB?0+02ua}_I z1yHxP-Av}1nhhwVMk8R z^>idEpP=4KiXL+Yns9To3G=s`5SB%KBaIO*r;YTqV~)VRFp4?ADb|l$)z5+TA9_B2 zRp^`&sB1&Ma$*Uk?lsShTzVOgA97G!n16b2;{4omYUj8ZrFFVdLYGp@;0g799JR3T z;E9nnyzuj(7W2DCVxD&-XOqY=I!2=9Yu5G`vF6^!gciI%E<8)WJz=ad-G~Eij2O;- zsoQkwXkN|6*oV|Zyq%3qXKKXrERE&04Ca^d3AKd}D|F`rl)AKS25A+LAPdSE{3W7MGLbmpPt|9!$*^!Bm>(MVCl?SxV-? zME`9oXD573=w8W)UAv8V`J6e>i!5k6Fb1+@q1&NMJUNz)qw5vAV(R1kX6$3CuhhNw zCmTz>nO74H5>9QRd&iQ*UYR0;{0yRbN8Yo$3b?^%cs`lW^=g<#b3WiM`zU|v@yBvr z!!l|e*XB7kM~@fnsh2&Hz1j#P)&`p}@HlmM#_%jQev~*N8@9q#45v)fCYkCyg)iEP{dLEYda+Wm4wF#~K(K(*8 z>Fvl+PtC)Ne;njvI(5yu(u;_-;pOCF8vSj>!dbPYO1WbBHjkbtE6LYHaJKbta({6i za;!7;dY6*>TOEysd(z=Hm9@`QCvjf#OHMrVM>1<%Ef%FCdtDwL`!^tyuE1C7ubm_p zIbsy+xC_Wb=lgOv9YF=zDDk{-;4TgodZyOMEAgqiREp)UD2Z_YI=X(Yoo|CWza0^zrXyy4L_xYQ-T zW^xvfAnF?q4x$b!=dk;yBQBc%u9YeY%d|L5meolSuBDEIM&!=(#++#K&;-DGtCv#?CZXLPfS1h`s0A!{`16$1SKb{Bu zc~=Qm^K)0Rui_sKuRqiABsLexGhF3R5;?LzsYlt9|6Ziy!yMKUFR8?SPk}sb6olyy zH(|-DbnKX!2S+!R94P!LPOAfO7u0J=Nk`7gJXEOXE+xtoN^ONd?o9pHH#{Ait+{yA z*HP?EMG_qvh(#6YQ+z26ZYQ`d`ZbU~-Kj%Y9DqMVqwt#itU;HDm(Y}e|8SW4xY8|_&hiT(xb~=Jnj>bAJ6^I-V81#UH=i zq}3V)qFZy0@oW@^J9F0LBzq*YoaA7AdZdk~Uvoh;{%mSS(P#eN6|U0EL4k%F$V+O- z@tvce^C`}o3xNIGO&EKH9P3|J;A(55A*M)u`fBU0ME6(N&z$?>*Pc3=b=so>c&-<4!xOJQQk1h?wR<}snm88z*l_+{rq;uvYkN(xvWx4!YeC7tik^9(} zU3{O~^d+C|A~S~;ilrub!y#N3hBSmI=r6RZfeiOjpegssYTct?Y|glsJ*J_idNO=c zv3x2Fz*6dUJ|`cl8XR_rA#*`15cWn3lt?r&+MqK@sq>!@!!9<^d!evOONC~K3p<^Xi%>%W;Z zbYp+3Lo)g3=Y^7A*bfiyQLpw|I@Wpd^DWy*R$ecZF)8GQ+tLr+)rO}@O#X|UnmuRvc`h{EmWg2x}UjUL=SEXX^VUQagF20kf-d?jwOZgI~yCnBCFBgT9j080%fj!se#T zt8@3uiT7^ULSI__8u}$X$fTc+LI?6k@$~tfl)n%){pnlXl75NIzh^&Ake@{!m=i`0 zsCyDtdC_0TU7^eQwqIhpXt48F1TI}8k2Z`m6>W6Aw}R;sm0pB zbLzoep*MtMIOe`dL}AxVIPl*)-X}?}w{^$4fC!WwZa~~RYELm9vp4ONT0K?BYY>hG z+mbjtmx(jv%j!n%mx()6X!VRxJI&UH;TTE_lzX}IuvaT3RU*Nwv zi}cBcCAxU|(&1mtbUk*pGGIeA{hsP7bZu{vr&FpC|2qO}_8Q^XlOCeOY&gwz*Mra1 z#hVN1^OXe0Blqy0+-u$M`^1GDaq|3dsJ0|wZZOwNM;q$-n#6jG{8Ap*dp30y-KpEi z^*HT#oSb7{>5V=DRd|2WYh^Dz0sNMTDVOPS+Fqec(NUMgNsSa&J^J%`vvbZwS_!Uq>X7vQ?hd=j;cyDz za~R1U3ik)E5&LDuad*sXMgI2zUnjrQjGSg2a$k#+RT%CYP7hTBd`?nV|B($p3aGa@ zO^y48aJ+j+pIDcBIK{lAXlk5v-Q|W)4I^-W8u{zpnW*yBhUYgDrH@U8auvv*+LExz zmIWN39w}a`=gn$U!0n#5WSvxF?q(YHq^U+T8s--5@dEWHB#F$Z+=X_c7n_l^DMJ#hC;7`CLapH`om{mpH7Rx435x4C0c zFFpP&M-KEvCc195;q!w1lAo#mPkX;-H=YX}vXR)-hJ;N<$+aWrPM;gYR0EcWa9tcP z#<;cd@;hIJmDIhpu}^1LBNHS0aQ`0`C(21G6t#skb7FQXlmRPMx?=?-zG1we6?< zb^SVTn2?%w*xGjRA*a-f*Q@%yN?7YxarG>}mPf)a{NEsoKw8sXH(D zwDtDCl8U(XsY~8oOg(kjcIs1hMZXDadZlK~n43D*u8!Zk35gQLI(nC2lN`!1ileVl z^kfxhFxQ>GJ5JP{OmhELl8hN{l#F_bvT+vuC3YoB)yfI-x@(dgi(tQ*zJr!$31VGm zl;&NN#djt3516|jm}8W?XAM$gC^b$eQg@gvqtYW$j$C8iKFcJ}Es1iwFj07hy1 zBfCx{>iT6_70*s_-2jcDBzhGNGQf{@_y%>2 zaQ=fji}v*4c#}z=yDSuHva!!82i_jph}l9WpEW6a)?9ksqBhU7EX?0bEk@SvCLYR0 zdq?U=uznVICJWalW}!=77J9H|m2f8;f1k_7jePn~kD-5HJI;Ep$U)7g+1M38ZO2Qj z`*FP&GgfOD${s|cY@|4`m$aJmyjMJ=bji9h{5$pIPN~J((_IE=J*4YUSBWa=F2{B? z68Agq@=ryT48H9y8Ry-k-sC1yGKF*MowO2h*IQaU_{i+7&T?`ky(FNL>bIyfH^x;u z%=3_PZ#*S>EqSc59-?&QjNW-?nOmM711Gf-a91TseVK34L*Pq}t8AU?EcJI3%l=ME zBn(mF?SAG*Rp_xmU)y=UN{p+iL{K)_s|Q8$_>%%(l$?q0ZHE)vl=!P8`?D*4%ZI88 z9PXsRg-bp#punDA3o}4u;|6t+v`^ z&j;3nqo`jupI(LEf6I2x%UxI4Ku_CZ`UWsJJ^Pkk zwfD(0szZ>>p7|gT&Y9+gpo4E9CiM!&`y~OeR3_KBH4q_d=~>;4d0(3le5u7c!CKZR z=7r#G$zaUv$UeKCY}L>pI9h|yv0E^zP~T`(2AMAMkKM14Ma*D6QHfeYUYw(!9fOd{ zF_?Zj8a2C6dw_NO%}Zht***pLy%{MujHPsIxo<8@^G?F_moM zLFP)|>47_rKhK|8Uy{9a3mL0!(bR3A4xI!4&OY|MnPjW(M5B#;EOxz%#`$gJwU*G6 zx1j}_zNX{SgLJg9;|#9R0(&P5Ua*dlxrsF|{#h}cS_6|U==I!;CpXfORgN|LRu;Uh zN)3QD)Bq@Hfj{$|*sEqNJWX9DzFz00nXE8*#r9@w7-UA%+vKs*$w{7~FT@ts`NcS;jsjp(i-^P6U15>}KBDIW0S*h{E{Fpr@ z-;!1|KE@f^`(&+tu`WL{AB(?Oagz18E&W)7xk^6kLOxoY$j9upWU1H_pRZvp-;Ycc zdmR&B(`PA`Gnc2VIGREI#}9d!oRNpmeBUd~c}v`7Z~wPe6!)Fv<84nln&B-uNn{=l zddPZepw0+uB#$~Ymdaf;5@x3r{j>)1sJXlB&2Sa%E44gPs-&OZMW&bWlETlfGH9_% zzEY>+Odqwh+~_T5$tpT<4m4#rH6D9;$eQz7sgbIZ;AI*a*UUrm`QK%iddSCDE|N!{ zVBX7y(sS}}$*-h9{a7-?eeHnmWPd9bNv1)8ZuWNMkvKEFp;(^xSE6kfB^I%-w(*Ao zhkn_ljgGpdR{BfNDwK2miljF6xL$I`^7>|*Jbqs+$4bQBFA_l3Xi5oGmc}uvsVl@a!vlbCe(Fe zP_qix#{4DalRllS)jf;i+Wj4c(fpqJ0a56EiCRRT}RBJ~|R(SM>hH6F9fsDIduQ#09vqy|>G?d+{B;JVe3^%%o>mlc{cXCGi)UpQoXxus zes)!#xvAyTeA~SmS3cDz$-!^S+G(k0-`q(ZWE|i2ceXY4sl%=|d)x=51syJR_Vw** zenao&`*olB$gh>6Lc1}WU$)+x=a5$7PH}3(M7MU^N;WuqYwx+XHJY6`TOq1c>W?uc z{0x6rPCHoodE04g8>hAWdqmqa&#tx&t2i^YRn#HB*JX~iIiT2{dU(CH?V)gk%&Tma z;A+VdKExy~FD6Pd=UJ{yFv#HN2GO-MN|z*qbTB7MOU|l}xR@mMPN&HC=p<3SpHps5~MtaVhWYH38AKB=4P{SziqD&H} zjh7cYP154BQS2o}5+@|co`Gt--k`;^^7P2sNZtQ6T3nq%4>;CR8oy*L$KFf>gBEqt z)I3Yn$epRh+j^YWi__58mU`U_)yR(0p!QfTN^PSy*G?_9^wjt;N{w-WYIK~W#!zyO zkH4wW{BJd;vqrFCq82^dYY^wG#dX$B4&2e=UIS`aFyDRkC+A2#$aG{=pSxQm8DGw` zjts|A1$mF~NccC`W5F?MX?aJWHTlIDFV63^rWW@_vMBwj%gFdo$KGCT<{2+4ayF(% z1ib!WjJThgS8Mf%n5BnXFZTaB>d8Duz~`zSEBU*Qwa{bkRO&Mx*JI>l_D(t97Vkrj z<0`#JImdhUXcFcX8Ij>^!v5h#%maIt(}*{nMH$*=X>V zGoLP5xcQv5xt;74j>>_SF=1tU>eh6m?nk>EykZZr_nK_XU(Na4Ls{7HEDPWGbBoOE zF~(&f_s?t;tmjPH9{O6(%)!2;I~FzkT)3YxK366^LyYs6{v+6!YEbSGK z`B_R zV(LVmqt@=9894FCOs@nBtZ&RHQ$+52j}`A0GUk|(kC6uMv(E1@Y?6=oUExg8OCS2q z`p8I!#?t$bCQ?|A8s(??dF@r8MgyMjkv0h-->7=TxtXc-=xjzG<)%Sc!SlDFG6(}5 zV*lemjy|RSpduExgkE8GG3d6J`U~V6dhW6S5!3-DKNHK(&-^wYyPM}@PTV`3983?< zr}@;hrcdT?A30ahM7HnqmE$F~;!&lAemyax=O=0iGfw=;>xx#J zF?t~5&s}5~H_?;(XC4A$tgz!b^OW&gYMCZ-+fO5@qna_lZY({bH8Q?(6KQqK4*NTl zK=YmoOf5k^B~QtHLWzqzL*aBM7zIaysAUj@BWHqOcOn!&EAm>7l3%RMIU~jmop#1x z;xOKy{)|=m88yCTMloaCNqx-FkqMd2-e=WL`Iy9bakPmX>L2u*=Jk~9azuP~8^!eA zBzbuWvU+2pbQxoif3|6HDTSMhn1 zYtN?E>lP#Gmtu~3%7DQ!+<%zAMug-b=`H8jSnn(2oP%oI7cTl|qXRuv4D91;$$jmA zP2VKe4i7w1=$!Q?DVUrhne?LYUU5La9Z8YTtTn!TsfBZh8nz~$DEUImJ`*((_Gn?c zPA%MYJ^b3~(QiI^bS1Tu@DW5BxW=t z(9F5SN36e&Am>>?y}w=5Y$BU-{#-UZ=2L&G!vAPjmj6O#a5PzvKa{$~yGpxyS&uEg5X$NH8IHP>osKvUb{G3{9FtDix z!zc1tI_ZhAw|OS=Je5}D|A+DUabZ2OVkD|nHo@(S0j@l=7Vxa=Jd*4w>yCSGv3}e# z8}gKXFRjT~vaY_fn6=jea-M!lT`%5~W$ZWHeyPx1jvyQIAVq@mIa6`VAPu|{ru z7S}V#(Iig<*7L;OI%GgfYyO+Hc*FUL^}dmqIgwhCWypfCRy(_WBsD$A6ZJNt+Bb5H z@9A@K(TI@yoF{EzK(AP`o};N5*_J$PXf~?G(bp=GXBvAC7jG+c3C9(>r@IuoL*!GM zA7kId!$)R5X(Fj*wbEt0yIl5D%dopz@##Qsh9D)9La7ZqU4gkt%!e-9q4uH>bovqu z%O3hnGdKB?7l?OX={MgZmYy5ToyU@aKg@i%S`4-~i$S%O7R+BkKF`mBxBV=b=$(O4 zjGgB`rEY&XHTAC2Q~7}v?F#bn_6`|lRTJsi$y2&5p?C4OhEiOynY4bamTGAV&JHT! z(%KHeDm&=EQY&^IzxsrrpluLzk-^Al9E@tELg)(-f?lIy@q9ZOIeiS~ZeyO_F9r_G zLvDF8R=4L_I@f~7x$KcvAm8|iJ_e&XdsN{aDl!&7NKR!sWAv}TxDP#UBGaa6#BHjN z_>O2QV;47-sdc<$9rMIv=k3sBA$iZw3QXp;%rq%cp+*S)>=c4B$ejPlnaDT``nSwLNAh|~iy7msX4E*!UTacKQ)qoZeD`Iy9A6Hg6f0z=&!ewxs$I2&s{C_=_cDU zE*&1f%y@i19~+Hi&6$f_TxLb|Cu&add@W&WEQN2I%8m+6_v#j`+)0n}rsP`MvSu=j{?5l)H}PQ}<;48TpL1Q^`FSOg|7?Nsa-61)b zt-)YlEry=(M0axL_XaUH8KcF>x{+|}7m3k}^wcDY#4I)Q3~KH9XiUgGY`|uoUDtaU z$;TSex`YYCCekl>Q4Yq>qDJkyY?Qph`1w^9URv0jB!AYQeC4Cf3S9-BUp0AclP^)1 z;2!J!w^Bq;&4QV)k|ld)q70r*KCdfl_;0n;vDd)<2=yyhd!kN2BtirADE*kT0lZf; z_tN8tXRGOy2~GN$P=e=asLF^*oX0xUh+51wb5Nok=hK^$!GFaW_HyLC9ka2C=lY61 zN?qj#yhrTUp5t{rJH)ef1^X9&9+&Q($uh5bvZOm6kiRP?%OV$Y_=i2A;yHTvff{X? zE4E&)hT?rB%#WBiH6#zPPLG?5sEbi85_|KEoCh#rO;Z!n9GEw$O|a)a4W8#q|H#4J z1fCmxIZMxLIcFwYKwt2O6BW8+pU5%tdPeeG-ORJTU;07Wnv)_O{^7M07^P{@A?a4> zptKsPMcz6sRxbAh`E%@~w#U6_>i^7)1o->)Tgbmh=@C*Kfol~a5vif3KI`+sGkx$g z*8680FiuIm#vfT2{)Rox<2)&R<4F^^gxs};K5E=pbZs!E+l zqZH}1DMi+@KhtJhvQ%<7C_eM4VcFOV9||;BK2eP)%h(rTPF#3Zi~71qZ2ihU#9;D_ z_w~s0ibSW9WI%6_W#m_@sYcwZM9qYs)O5-wV|hA@n(^7_(lZ;Sj%UHpCmYuD^iR63 z(0%bx>Q=icbsfk(jG4)M^yYtg#w%ayNSR%~sj>o$)MlpD9(NNbP;{O?~*#sA9F5jf~hn0!dm8{;tWTbev7

YmD()?v zsCQP+O=^#_Nv-g}|E|YrnHeW^R%+xs$&Z)C^2M-Zr&P% z_4ZN7vu7Suhx2ttm6+C1ACUerKd2w@DUbU&&sc38M_E0*Sh7lUE+Q@p_nUKHAJ19f zM~+giE;+%M%tL!}{`o>0JT~MZlfL1j-~X0HJl{i)lP_P-d4J|n`HkpHTlu%#b)?^u z%fJ3eX8NwMp8c|(jAlRNqcBe4zO8M@dfrYe@}!3B9c`0aEBxU(oxa|UIVZ^a*{|V_ za+&&-)#&3~h5dmFXVS3ud@iPCIZLNszr^uHKinr*mGe9eOEdGRSI|h_S1yoB+xa|n ziNUv=G^nEU=zr)aP6-9_!zB&a{KkF9nD&>t@fnH%Waz}jfd zB4=3>SRid8g0S}x`CQgePVx*M96N_2Z1ZV;(9l zQOQ}K0y$HWwfoYnYx||+&QtpEgw~c$zl){Y*+8h{3p98xS%X4djq zAMduBTH@WTXtuyv_PnF-6YsMtbp<+BV4eCO&cV-cmg7CBsgT_dGx>aeUSmd5bu0eL zX(;oX707(&fdAqt`=!)NP0Yig$_>Q((=Qn~ED%$<|Fr9yj9Q$*je%pTvF^_rs1Q>dS>OMe@87eWX6HA66zEFFIIJ zrH+fNx3@_cHBFZGpti_l_MevJaaPth)zu#_tkgicOT*vESO(r3A-zTaJv_ZNvLy{j%CjlzU_^tGQ) zzxclH62pDqoHhXC8Migyy1T)i(+cYF7A5}{Reyg>8cn^|_US0~Fb@aw>Pyj~U-Fjc z#nFB2_XY6!7x7&9?I;y^f0~27RCS`D;Qcvs=U@KXP3}ziDdkwVyO_U;v$pA|b|V*u zvZ_gjC%yCb2Elo66t3+eAI)51a1&2?Q^h9J&Hfn4{p93e>S@O3;k40F9vmr@yHNqS zNL|Y$k97F(dF%c@PNr4xzoF*SJXcTZua&ob?6q^2uOc~3->URFqW=dQ$$v~; zIdcTsdK>WZHFfch(qH)fe)*>JK-~%9=-k(UmCNp7eiMbR(~vm1Qd^C3`4OlwkN+;l zq1%TjblHq~M+d5Lxf5&ToOcP>k%ff@8#VO|QaMz| z9|Pmbzp4ASEE8>ObDqN?PPVjD;W4?t=>rUyRGsk}x!2IQ31VL2&g&#M>R`YN2iB?U zFh*LRAQ`^yWKF_wu|EBjSl=4ci8HZ%ljLke`utYr_1sKCBR(hX7*}mii)VTUiFNk;> z22;oIc};iR_YOy3EIGLEnaK2_w)VRO*+D+Bn7xf|JIGbd$-?pZHdLsZC}XR8a6Xbe z<}~VS4Wtjp2pc_ac8eRYC!7A%fAMpyx*&`3t&N^M@v=Rd9M;QlY~%ay*g)>DD|HFq zB}#3O`wNahGC!~N@tLd>D0J1!>=(QD?&!8rxbUtt*hnd^El zH5yJ+FY@U=@eLw3s#%C`Kd8T%Nqt6gWcso3QmZX>)ySh=c*W;oC3W3bvfdVHl=?s1 z@yFYR*!IzY3(kz)In&$yd7|WpyTPqqI8L5SLio>2`d8YJRf+W`YH-}09*)thsclp7 z``yS1_Kp{u8+p&x;mE3Nz={|?|GVg;O`XsguRP$KrALV|Nw^Z6g^XqjorhPvRJ+9) z;F_GVok@OnF1eX8)Pbd6ZVr91FMXpQtv&TsKXYGlA^*EDPG0( z-MJ*hC1>K>ZStq&tY?o>qduS8)~?jRXim+F*ETXq@zQRD8Wc%^V*?|qRLVlt6i-*^L^M)O)R$gt}o_aC~M%-*K!}$8aBr;y&4#UIBa_g1Db#fV}5W zdbu?V$H&9;dEY}_*Y*nC&p`6v%;o-2UvI*3?;> z&ZnYR@|l@YyZt8Wccli8m$QF8oYlJDi598GV@YR=N7qSRnOq@lS@{ZSOP)uhmfl#o z-MmBgX~E%*QxneUQa87|bGB*5tJICft5eN4;-s^I?DhRbd9lMFx!p{%WiHQ9^5iGz zg|s{@UTW(T<-l5loa4RvOjhyaKZ){MMLp%elcY1(+3JQ#GLk+I$7Y&jZv(#0vnTCD zqMSZQEgsG(j-z)+V!ly2p5bS6$|(Nf>~nLy9U%KVoqS`drSY=#6uH~J2Kl{`{?fi` zJpPM*9`uKf{acM{Rp`f1mVaKLX9R0E4Jv7|HJrYHKlnKx<{8TU;vCP?s?)S^DZ_eq zX%+T&QseA(a{j$Jd&ru68`f6hm(W+7v;CO^RQUOWULpOc=hL2=rvLW2tEf>rNke@m zYS_->xjB~FJ_%YxUyMLdNj-c9kT)bdKBxlgLS&WaeT~4TB5LEz)?>?KKFd!c;K}+? z!5jJx(wn-|4m~|_ijqn=PJ)IhK2N8AIs@ANKb&sxo{f%G6e!}nmndc4Vi znR5*AzQW$a1MbIj4LH=oh~>MTRG6xi1H&1Xj7khkBoCp1agmN zZ=h`m&$vff=&7Mspp|Um^=$N+$9h!lY|cor{-R<{i2ID=6MDV#9GicFy{OzwbYk7Z z&@>xiWY@p4Z+%0Th1mY|ldhkQ_`n=`xR77W%0ef;=QYN2-~J+VzlZz4bZYgme`GC_ zg&H%c#~hGNeNK0AadMWb%p1v z@U;}Vs_8cQP1dk~k7D`mset~iO&sitq)A1aINr8NqjpLhu0{`{k4jvfT`V0rA7omg zfUluQwptXZN?p3OWVCd%ZF1>ck#smyELEr4q~Aem5bUJhBQ+i49~R2(Z06S`ilxL1 z1xf@2;kt7W+;32igUc!eU(p4=ky49&_w&Y6>? z+C)tta)<{U>4DTL5Zgxvq0}CKyj>WK5!-?=f&63h?E#qQ5rlxGAcO@|KWIS!u6Cm~ zgnuyZ#dC)2GUv<2(igE$AWq#2M!k5>Dn5&ZGc=g;ftjpP!8k9DGPmo}RuIVtt91(%*N4?9bSYFawf7tQ3DE$H}(9?_Gi+j!WFUN_TGWj||O-OL!# z(E?e{x_O|5^9Ss|kmI^Gk=jVi?VbBrFyx^btAd%IZ!u#jxvl!=%xKq+HTMnt{mHBo zT`}W+Kt9%ZQ451?VfF=jSp_k-(y(68o|JtYr!PFZoOfOEG) z=wW-sifQ%PXP%Rfm4DEWt1fkYSVMWoo<`h|d>lK+?`8ja@HqDDCsN1p2=m2hdGO0( z-HrW*Q?uDC3L{I&Jl?J}dsf5wy?V|OH_%9rnp#OM^yci6i###7Nyfn@^2ndHw4SbH zGgtthIz=(2ydDElHTkeG%_R{~KmgtNflTx+*L==pvtGJ`Q^1--TC5C5I-d-^9i$TWY9xJn*D z6$Hn7tEgkD@P^X}0jtueiACQ$Em0%z3g#9)%JM$?*n z;~LJs^Yv@p$vpmw#-Nt$X&#Sej>fg-5QDVMTuUvZP;&`;jI8&Zs}+OHsA%+F5RF~; zspEKq>+vT2s})>Jf78DrJqj0nxn}?3`&;;4L#YY5G8%6d@oRkyUbE-tbT1v9UU6QO zeXa?I%&0kzHP`X1-&Upnmmi;fOFCw7-CZ7K#>j5`Z+?&V5q*eQJBk}?#=L*1hZ?{& zWae5)QAhBb3JuGZ^7v2W(;V}+T9ZR zX7J}%th3^08Tv@OkyW{u$KDoaRX6A3RGO9gdR9ChNbjJ-oSRL~!--tJ#&w|FX+?G) zu93H_-zco8^pM&ocex&oc`!%kK||iL&3nF{L)}x>=KJ2WVu6Y^`kC~7=Q>@-9@=;{ z*VT0XZmz)%d=KIGT`a-+;I55+e|TL=T~rv5`d6jhslQU1rJX%!NPV#GM`}djnYIl| z9P*o+`21{}@PO12y=$ip*xKCBwxYt>f@h0U$CS!Xb(&-H)A%Kwo!Iku>dxB7&jyxh zm-=ORg|m?_Yp1?hKGg4ajmxQ*8e3B>2NTZ>DqNH5e$zSi&5P92UoX{6J+$uR8HYy~ zQ=1)JmHJ4TnA&dk@>JJViSnRsyp-LRB=4rA$R$mZEObkj=m{oSeLYFGO-Yp5oMXAm z`6ZvtCh^^6kfIYQvTe0Ne*9pZ*WD;jbxAUONwU=D+)MDiB$>F~Bp?1TNo+fVOkq42 z{DAD@PtM8B+%Ny!FvyKgDKgI9C~Ho{N!f%r33D(?vexJEy{m)hdKBmYlat zi?2P@7%`p9VWUXuD6yX@k+}LNJ*L%UDjsq!>xdpxDpQZ-oSt009&aK!>(`guB6G%q zkKuUKhqI&nT0`ypG4u5Z+rk-{CX6@7k)6>pE@VyW>oz@lPG&8Lap#0ZoH_i9IvMut zE1inKknZ8A?99CMdj!Uh(xc=zJvK5{yE%n%UJz%+T9Z+nK`(~o2E5zHoPPs#{udkY zX^0W_teJh`|NAhBUK6)imnunZ?qVZidm2#gG1;LV?7uqGTlFDxpI=EhIn;nhlc-5n zjoge6c^NOpjBUvAv^QeJaU=H4rKb05GAyIWP;w45q^=30x^SlER3V6F7j7vJb)y`#Ocf}kuWe-^OJ{yZxk=Yrag}v@%8GRXZ?&MrDzwh&GYCp2(7PT}R zYpVS(&*+rZM2?s95<8`*$a^md+v_RUuer*+7u4%5vO`2KC9X7MPoL+5KPbo@pEG@W9oN_6O>z$Y&|4DF%7k(UbS*zZ}u7*91R7`p;P(QO%Z zzqc^X+epviwLA;RwLe`HgCuXpdNpFPmG@)`W2YxyEl6`BtIj>U*$48TudImI#KHAL*A%h!((C8TIB=J6dXAH=*YgH9$bN}RZRJ6ePx&<4y zSm3k7Lj4PBS_WG&Wp_R`$r&Skrx#@?*-sny>e*UqANWZ239Zbj=_U6bXr;*kl{9{? zKqIm{Hpdc}c1nRE6Y2YEQvj7i@a7pgkS~m{BZJ7h1z~9WAoi%JKNb`XpJCJ_9~^@x z^QZxKJ{o(;TU66q;C{x!Ib{nzE~iewo(#?hSz+Ik{Od_F@#F{}^6QFFx4U{%aqg#; zK{YhuKGs{thBOfeeG@sBqr`wMHc7g{I3}L+Q&3`slA3KTL!qf1f(=(g@bq>Fo^PVh zD*2Q(EqM(WqH%#|_~)~HuA5R<^I8nvwzNCufd(Is#u0b6>ndKjmHQopUd_zMDF*%wMm@G3VsIvzqJQ*C!iwD^bhU zm<4CDgH7GJAFO2!iwu~G+{1L0Qm1;Q(6u^2O`v^=(!DTQI@U;*FO!nxL)Qd(RyA3o zR%mf?odzd*(1$XH^TXfNxW$@+tpoS*R@B?#p4#nI1m3RFV|+dOJTs4;!@PI6)rg0; zjCd4hfW89#7T-{Bwnh$CU1J_fjiRK6IVhZ(gBGl@j#!}3Js=l%y{AG~{(wT)fDFWv z(?;3oo-7XnO!U4;lI|~!obNHpiCe5IueliUiTmvC2lPxxr+$M6_whC4EvHf+l8j73bPl}_$$7qKz4~89gxZj= zv`XFoA?>XHn%=|rKd?nTc1uZaAS!m=*Ywy)46(brj|yyd7YqYiscqPCPzJ;9B*h9rJ-n`=#*ZsV&Yobn}wp+{NA>VkGeojI3Zi-4dD#@FUOJ`?# zY0__bGquUTzEcCK=7(M*e395u1zc1jfyd~#^)`Z(tv$5Neo|>9$EIvk_@eq3*$)PSHAJd1&l0mLA+Q9QvpimED zUE^8fgR)3_P%PDtNay^6ayP&r;gKfk+n4^8&MK%mFHeFm+M9i#AU|kNE#@ZA%dj@g zSgrFPTeKK`pXd;?%!pMNn9oC&sN_f!sx@X$_Xp}3``LrJkp5rCv#{j`^BxXo;bsss zVE3?wF@*ib6Hv_ywmF*>Z;szo2(&)a?JS$UPYH1`Z(Lm>)U8Bwx<2~+R! zST2%h8cp4!b2bc*v)G%(xow3){i#r))|27+*w{|}Umo@;EA`kZesb&!*}*c6Wpk>Z zGqCH$cTUld&!2UZv`}J2?F-!3QDJ}B=a(nI5 ztw`s-u;;2KQm&w>-QwwxH5U?$0^)Oy+!A z?0Xi&1L$?k_4JT=R-Boe2ft-`P<>*qz?A0F?RaCUy3|ivw`nA6k{gM>4fl&niey~{ zd(H_Ydi8iDfDK1P9C57*ML@j61U4=9t1IKq?(s}=;be$tjs6Zm0-WIJpyvczqe4J zZf6B1Ut(Tga0r@r8i4YvIkz4gfN0KPWjJ@0;yF5-6ph9gqY;+JJ)V_(rHS{9g5H&1 zd98RXW!F$6$)bkRi1*4CzW!mx^DX+;f6BuX){Ad9^pm2h)YxYEv##4(^!uAg0<+7X zc2uC^Z+lF<%(?54O@`g02b~J?P1Lh8)-l5Ax_?YK%xC`YVfGI#Hlm7+zURRlZ!*cdKc|mf3K_z$SYdJ)MP>iCm*^=lGYVP=97k#Kt=JCe9a|`Y6=Noeffv$Mn*cBn?j*#hJb+ z{hB0*XANIWui=9+y?o%sIc&0uwLJC;oKTVToU6mN`Si1S!Trq{Ejkvl*Xtm2hB&9L zF&UXFVnV4YMi|*o8*jL0d*|kZ-+Q(6J|^o) zrZU-6hYsuM({Yw_8TUSCukuyNgwUZzJUdU`vyKS|i?h(>X*N=`>Hq$g=f^o4Bj_<4 z#2y6&y$5qYDb$a79Nk&-oIaEF(@ROB4l_yc6qD5NktFXu5@fVBQLHCaa4F%7Ps3C= zdC(i9S*u#W<7xc24q>c4KAxe)u?jkLIiSN$;asmaBAxTY;ua>;qAjyky-A^bI^o4(_3|#2fxdOfTx)8}t~)|5dQ#I`(q&kYESVJq zrwMulHl&WVf*e+|m)O%!t@vC3jL#zx`Z5isQ1;NqdCNQc7o@deC;XQvbZwf3xX2u& zvS)i-r$Tw$I0$hQBXQ?+8ro5({aB;EZA(nTf+BO z(Id{@g7|^tyzV+nRYShinIC|?)0nr*{Z>dr@_L;eW$O*j$=k`t>GTMvu6>w&y!%hM z$>C1L^2s3xXUXrh38haTkMqD*H>t{`f;!Kc&-*441tH{{YUjdbBY9GfVsY3IfC+yh zq3=b%vx(dj40e$rDfC~vK%Q$l^?AosdJd8MEAJ$chl^!S=>S}cibTw_G^jez2aUdR z@9x?p&@Kpd9z@d1o%znmIXHi+j@)})Am;o)OuiO{>LrPSjmh1V6CFW%_t14!=A%GIq*JS zS9*Uhl!H}*FuERfP-QBr&&!4WKm#dJxZM*%->FbaY!ATQ zz4UP#or(kGo67BQkr~r|%eY~I%nyyktvqtIE>^^sY$$iR`NN!L-k;QnfAcu6lk+;)lU!I!)|dJ*|9x;Y&IG2hN1MN|+C`$X3#1C`Ife*5 zQm3)jQ8fo{dQT}isZj0=WR1v`eVj*A(d|(V-mGsZH3$EZBJzy>J);rZCk@q?TCuOS ztJL88uQjD##&~jY+BC!mbG@XaU+2j}X*`|%{sW@$F)xdPkk}C z&`)p`bD4{IpL8S7>tw}(AQySXdcunmfq4Hl63+jm(l}%~=63SB}Df5%k62eOP~LU3p!eHAME_czNmJ(2KltW-fLzn{MiX zLb3D=#LWAVcuIaSX=yH^f?cKb>>_E)^V4)kBnB>`SHRv}9Qy7gLwXiSZRXlPnHt56 zUJG1va}ev_K;EkJ>h?%8@%kz9NkgugkSn3r2{X{;4N%j-!w zub*;qUm$y!cwIRD7$@bRR)&-8cwZn-j|L(lKN77uzSXHm9&@0RY+q0yD);`F!~5Bn zI2C%!2FW1Hy_(wKcH?Q=2jo|}BGT_{^Q9*+7Qg=ys9C-=0X!V^bX zB}H;!N-*?lJ@(w9zvKscd&IcP{MLmsa+wAp+~*d9f8fLiOY zPShqn=>NYYR#sX)5qc^d!?qj9<7ePc2^)GHPn0{2y)dSh7Dp=@(25#rW_hkJj>gLP zY2NH%(IQPl4I=p-zENjbdMsXguO}~dAsn^bm?yiHHTB;%eA<0LvZl}<&^-(VLkx(h zNlk#<+`MiH;xIu8*Nya4I+cjeg`PHa!z3yllwcNxrGK zH@V7ibe&2^auRN?1bxFH;gVB4!4E|Ox>P=&E$QKw`blbk8@~fIPUFEr$bDftj-Wxs|wj}oBhm5Gn{ZTQpDAWc_$LA_!jMm0}_zdieu z`1@{t7AM1=ctZ0}7|gkeNDU%~#WieS&p4^H#T)8~FwDQrwN(xJJ4M)#Vt+sa$*=TI z=jXeS53P^|T{{~hYRAgj=k)mUjKF}U?4{jKU$z2ri|W1NQAl>CT{vWFBK9B8z@{_2 zjyGc^_q`Vszr(TjFmshWGLYoN{-`AKn0haiIu-%Lzx0pu&A^mK=vjyyv$>#MzMt*=EDpReUa3lQAs`XI@((ibrRn(2qQGoc?89;5 z`I3HoO~cTbY)oO74D_8+40A@TY;WL+%-X!qH`2o^g`66B)v|8!vNDfr^0xE`Oh|-< z&z-|w8%F+&m-t9>ZRA+zyBd%>j``qydES1LcdO%#bT@v^3i>~+&t$JVeI!f9OPQtK z7{U8L@09_22eIZcnLOi2=8U}Z!pFy2G~n7<(#ePB*_fl4Am?6t)3-PbickZ#^FG;< zU5vl##>vmN%n=^L>*a4CYmk8k4fuSGjuW@N?4hG?MK$i1dK6{gW1K?0@egyT-+IEo zWCXso`X65P4fV5g%6MrO#{KDe@~wQXCppu{@P`fE=fujdsh)6h;n!WMgVoK%tcy0J zohHYs@xteh;TZXg=jU?8<$I9Xa(|-<(|!?edXn@H!;c+_c86z0mSU7`mDh zFy}peWBL0ACLWLlJyH!ovGOxy^vWW6Y!H_&lLRtZbRB!gF&NlFlSz!5sEh^Y=Xfex2j$WqU1rjwIs! z;tb3mXG4Qk`=so2Z%j#E1hbC3dEz~+-)cj7_FGRV=>^kt_Qg3F5PBs8vp9~q1;@!+ z^0_fSVW>2M{-Gt^g7&p9EHnFQ8k!GWsbG$|KA`>GuQ$z=HEqrA#~+(Fj#Z?l zSH7PT+~=OztA)PZICa~$v8+D_T}~2(Z@fI9*XA*Yc=`K>K^_h<%7i?6)skm_Lft=^ z++m&GCb7>kO7&_6={3S6>qaI@cIN}qw4p)1QE$#`pCp|)UVX@nmr_9ODg=w6|d#1E_rR! zJ}(4xP~yf!W>|!hIpnkTbD5Gg6mLwvtwO;DZ``TRoQ;Y6dosNQwyVhSDAD(V7Ybi7 zha;U?^fmchM|$IwFYDN!nbkg%`P7^v$bTxw03(Lj=OL5qJ|8 zj`QauFq-e*RUF0)l5q5CqlKPY#bs(bYaHqS;KZJYG%cFfCeN6|p3I6`Y?=@O)e`FQ z&9%%LjlkdT)LO3b*o|9d#HhRx5=w>08>Cw@;JJ$#z5 z4|J;$F4UIp45ok2ZTc|QXAa>idhb*>;wa}c3pJk+S6JKGNxo1=uf#f;7+ai)W3{s| zZwUQ%qRGEUWTL$y3lAP;V)_a4($qVq24pf1Gy``zE;grTcJ@yeMx4*Ywk=uMJBmI& ze9lHk(yO2;GpoyzmE<_K?*=`psq^=3nT513?8|7voNE4DJ=Z$b=VxP~ne}Ye!XNNe z_M(^Eoz+O{wDlC*W>0Z==OyLlHI!BKR(v=_C2`d~<$=4mI5zNJfDB23e?42OX7-EyYo;KM$fs9s-5?Dm@~2n zkUbo(p}$!mZU>QF{H#G@ELo@_!SLA|f`6!yn7xCcoE(V37lW{JIr&BZVBAR!#`|{~ zGT%XXdY=2g-}H*}<=3e>4H*y&$1&WK`wqasO2Ig-)u77kAl&F54C8Fp+tooR=*r$l zezxo9Kn$S%u;yzpT&J>Ub~?EyYT&&tvVZV8`KOuDFf5Kj&&7H?urc@cb`<7QYx(98 zjmQvY8nAzF!AE)m^dO&DL603H^ypS28vXn0aV<3(tLt+A%vwlv7CFXeQ8;j)-gJK4 zn^$EGULpeD;BjOT#~PSs!R=LDS@PbZljT zV|Uh4zNW!h!`uW{{<|r2C#G94JKchDr7dXtFb%)S2rR3bj=!nfkG-FUO<`%w^Ja}9 zkUZ6C3+5^;P@cEoLlgQ-tmpSgI;tt?y|dT?EKkF#GU>S4n*ZO7dDTT0d@h#`rz%zy zIa;Y*Fz0qAGie=j@un?37u&P$|1%dO`}5ze@^IlOGp-7Av94_%iU*R5s%k}_DfEe$ zMlZR8+=o-^3dx|(lWfIZ9s2{PGG}QRYvNt_*-fli!oA-%pFHe*$?qL%MJC^0KbyHJ zW32e|iFz16yFb~h_&8q)Y|UQ2jt%A487JxC!`$aeO=No~Z>enWEk`!Ao zwJo{C+VnkL)=0um`bzJ;Zt~%(Cws0{vZ=JUc=qy?e@`l<4msf8$Gl`}inn;>(U;NJ zM}l?k^4io$`k(TWH(%W(!LgCNa%d<{yWHg`nacA&J!Matr;OXlEXCh;X!zu}e5t6w z#977iJirbgKGE#j5XR9fD8Jm#hm`xrrRF5CCqF|k& zN4a)-s1xbQXwp+xV*mFsJw_g)r&dE|nRTT;@_^6Zh$z$ypvUQRX2AbVCNhn@1+}hI z_IeEDb5z_>j{$uCa_>YzrDV^%AL~f@Q8>|@d2w_3o<6KivQFCRPZVn}Y1mxKg2s*L zn@G*1QAZ2Bs6pY&?UZh(%+O^M}9pEN?c_7wI0s!F*nhr^%nI2IpX+33LUMr%R@5MmnAI&08#Y;CT)?{Nw_Ma_ zrkr18GQ@q!0wpmwBPEwTtK^FLeNSGpFO)U9QKPKf_w$+gNKUx971>5B8c^f)A7{l* zYYyD`49>kupH+U=u;saU+LD~ijtk~Ky8S6PdOc2=5KuF9^wgK;OS$D!t4@B@u5G(K z^Q{#+bN{r?Z!D%IN^`FbR!WywwLH22Dz4-bD~Zdqr!`NgBc_F;PWRKFVu=4TJroVmC1in+c2 zUUT?sm3igbShMSuz9~o8k22HFC}ZeHf1bT6ovN^|SI;OT*-uwgoG9aR;$_&BM7iy0 zloNC5k@2@drteOYmiyx6NP4`)@ckLguE@+Z$<{sxWixwRX1FIx$V>8yiShEvKT&eL z*-IHi??&cH7k6OK3wx4u^o1;IHb|YMIB~s@ApPj$UDPQ_hFv9}I9Q1jTpM1=@kXP@ zN^H5WqPG_Fr`xMAg?xdJ9W%~4d&8gX!`O5$^y;NV@=x|waZPzQ&>J4JnG?5*zKpE9 z{e8(3XA`{fG29zD551A5Q^LLxb%amcE0{ddE`c5zcI0mgRY*%xLRE<#{xiH$ae)uk zo$$q4XV!emYf+^){TAur|9q(y+WA`iOpU;#2-c@sN1$~Ed#miYetgd!I_~eC&uQ`Z zYYRwc;8I%bCD-FnAsl+HJB#dfm>Czr-&Y6y6)j48(3|lY^8nZf z^J8x~Vz~yLv5PgY&)i$HR(Y3u-Otnl7PesB^l2hC3^u}(Y~%E629)AnH0K`!YP?|P zG}n*i$OkoHUCMtAwX+S(k>*;jQ3E6D=?&=a$3MFoaq$rMqcGtg>H?NMXGgnD=;@;Z?%Oy_!V z2zyeJGcn24)MmO5Bd5rqfq4}@ z`8@+zyKBqrjZO69&nKh9I+`anyHl)pqDvN1`Tu#@TqEw!L`EF7v!z+6bSVq}p3Q>Y zqW|R?OPW=Z{?t)+{Od24pr+E%$5Y-;Z6qtnt$(2xud}@Zr`Fmb`lbR~`EQ?cAvk(2 z7%}v3+Bz}>#o_eUyUyI;wb4KVS?|ZJEo_QL^-^TNa>%H0{PD<4$DB%M(TC&F?fMox zX3s*m=T;Q3mLE7H5B`JbdtkM~Og3cGmqy~3+d|eIqqp~AAGt<8#MZHi)ELLC>vsx_ z+^@ic$IK1QwaLc?3S8xU683;z7$=y!!{howKkP-zHO%Uy*FwE5C~+(rt#;`V97-mw zEc2!(S}^_uGtB-?N2T8uOrMaBHT0Ky8JmY5$8*szn7kgxAN$Q@t~o|^%IhHSlYQm( zEqW<$Yb4z^vMv(tCp|uK{!38cS${jsa3W*5(;tpmU4{6X$E_F|C2NfWF>d zJWo@$Fw2@AgeS?x4@jqdJfr?@l*_B}2Bl}Q~ylFG85%->AMtI3Bc;*mIzBwA+QR$cvcovZ}$vu#> zT+KDx39|)BTC%1mt$6Ck4DLGglB#QkGuK-_>|0tm%}s*dsO0<|cc~ssma(vjxYSjk zOLnpBHYpJIojznmHgW7ghHzUjt|bQH$>m@ie-(_BI1L7KE&cc*Ye~iI+j+(L_bv0% z(&>B5Idlx?KeyUvp@_C%vx|kdb~^f#Q;EKshgx=dIPf|bUM^P5{@aSHjp@A=;wATY zH`~dr9={)OozJz!suf(P_adLt zGX&H1^p7mH1(Cn>$YHIo)JHwG6)+=iFg?@$wZO{tXv`qa!*eWXy~2VE3+X$~W3l5} zu}iHyw6e2eR68q~1+x8L4YKs7QSO{&U+cod;@T!r^kNk4FBLT!CHm3l?;Bt5G(MQ` z>Uohu_&3dyFjjHyz%*(ZX>&dANKdW}P8daM}pvX%qPs`oaFn!tD$6*V~$f zHfvbR|Hhnv7TI`5FR9EO>_?^NUv28hjmS3c<-dC=k4W3?Cgy}4kr~k@`E}1Es_zE* zPLJOjiAv1>L{25o2Zj=ViiQ!R+

53LT%t#X`a*-QHQ1DQDLv28vpkyBqqzd$d{+(TyWlolWJwWz&{OiHR2 zo)+@)kLme$$p{~wpFj_CpW!?|WGk0;BmZgS`Qbi1U`iG~PbSO#j=42tx?N`|)NTK= zQ?GeXkB9Z-JWnaq^<3=Kix4L%Cya8i-a+vmlPD(o9^~F3KjT7w$j|h)qP`Nj!k3(+ z5A}N`Ht*s*H%N<4WjKe;)1mVSEmo;`j>;LacbgHDzA)?IF?%jKzqHuJyolFX2+SaZ zF@?U2&g9r*=|6EH10Tr9^m#xZ#52rT>Y-3yWi4paCWU&&4dyM;7rONk`ahFHow+4R zGO|rl`nC#AGgVmghyKamsre{XxE<~bUwR?O=1?=9q{A=How0f?@=I_oJx71E4eY_J z%Q+3q2j{VEre1q5HJjdSWEwdyEp5ZxYo4F!v+1dMo%{vsJYP35%V)7d{h+5py&{cu z5ccgJdYmLxxE`wb@rXFhG|KS#Nz%@d=Y`j6+)!VPxU9tS(Z1NZTZMYdnbp~Zy$EDw zY#nqM)Iy7xC>@^cHsL`b=h9Q`GrdheGGA&m3Cz|gNqw4+|C_p#biOg594{_J-u&hGnu$tDWk}wZBRFn3HOxJ{H0RH#ukaoFa?IG$amY> zWTe_2A&2eI?WP88=5o)`hWi6^2zDj1{y&j>lsWWcToMh(=h0Znu`%|D9#6Q=-yBG< zKbr-|?b0zz$F(?ly=PA3^4Y61dm&l#9rQpPlZWOZd6-y~i(`ZRr8)WcZSOfIlaX69 z&{q;;Jfut=JM7Wg<4c8-I6qr~aH9g1TH3+4p9bHnhCo+egTh*z$EFOxp+GX{59kX! zfEmwE*=IF{eO6nU+wc!x$GA84NymX^=~(s5f=3o<6rYFa%Je<{$Z_xq zJ#ko%ezw#{dIh(Xq)shm`!sJU#Xh=s5zWNw)_;t-9fq|dLs-!c(-#*?rylm`!nwS9 zGW)-V4?y)0dNW=Qfn$>a*vuub3=kZO+7apZjp)IP`~^T{Fm+yZ<34M+U5a20cm=6zX=B4$Afq z2KmI^uj(*K$pc35-EERnV|;+eO8mahKMOdIUG}9XEBmob9B&?I;l;Yi!3$cf^w6QW zmX7`EMhvEQYv5cuslE}R)PaxOH6Wb~+Ta%K3E-TyYj748a@~AyCpF!xtl2!_G5jW5 zd7CUX$Hn7+v5v|9ghli@e!cCWJU?raylX~jRsW#ajrT=dLlr)4^+j8b(^opG5U8Y| z?)}9$_n00lb?7;GMvL~{n5A5idCw0y9;X{o-p5F0*+4%UBNDi;IDR$@>7U4aa&BM4 zIsV>I&S7`i<3w-TEtl!%vV>kZ~(V^v2@_KW0h`+%(Ka<{v)l8VkT3^l} zBhIX5UePR$(bSgz*}4(-S#|_TgL+LaveH^&&EsIlGKf zYE--oox{XoioWQ+pWec&wfNVGo}SSW ztiS8fW0($YH=9`ZFrw)v1E!2*eJYPy{CFdx=44~_V`g$I=?7Ai>}fnb1PocoCQrG) z8#%^~3iYp63iW-?VL@Db=(;D$=f&J}k2xq(a8Ul*OFyMcM)_WiEN)vBLYH&D>q8EI zJu|WT_@Kx~hmG9Jmf-bzQALOMlXdvgo*7i$CggIj*T~<5u{-D+`ON@js0m3LW|MDY zO|}l#WGCqHv^*1^`}3H}GMk+1opsOXtI58F4o4MgP5l4zj4#X{(y2CcQbL0;uM(fr zvuOx!X2t%xb)@gtA{lqIKYCw@LguS9`ZVRDdm|^w2q=^@1^v+3NsqUNRD7RBU%#F1 zvY$R>3z%=)$CrAOhGWlcE3S8Qm3QRbIwc3<26bb@KJGExm~l@oZv?YjA~y$N%+n~G z8N@v0Usim);V2ht6-fBz0QRZqk+qf_;sR=|^_-+><$SrYy&t?kZN{Wy>^HiegOXmIneK zl8d>PhH_lXtMZ*?iN6B%3jd5J~1%eL27)mXD&DAuNrKaVicNN3cBH4DKKYBi4 zp6o^PswZ+V(~kaAM-qi zF1KLAxm-kqk~`y`$md6Y%-hRcV;wceJGmG+*+rb0Gh6d-9#4H{%~(^(gs``Nyob#E zPCq;T+_i_PY0gQ*@;c0|E@~j>9ExOMBj!_iGq0w<1qXQ^9`tdOBYlfSM?P-o1lAOI zetJ%z9=NT6R9%)Yr+P4dX8`wA*=ewUnTzPwE;5_`j0c!UJhmhI4$E7Rsm*1*u%75b z3q)5p2y<$(r#yu@%Tsd@aokycJuVQ}s37#2$NENyg*kQXL1d=U$2Eo0pFQubIp3X3 zPDO>oIat!LzC3-9FC!ZS(4!;@ky$+d4m_Xt9mQpGft*$J$B<^^<5O}wsS7Y5}g9Udsk~{Wxk@#`+(_9^dOkUqI z?@}>)S}xqCG!XyG#bO`I^UyO2KY0I?Qj%BQQBPXz%9o#a1JQ) z$m5rItPMbobowwxk%v{#2eX8e1U@Q|FE@e^{ukFd=hG09Y{l5EUh?;?Uvj8xAZC3h zcSf#x+l^d==eWq8y9JWpf?9cF@`L*=^n2uWAvYKKpipYtm?W6)o2=9@=bd}!)m5l%x3yxir?Y&Y!0ZU-Dc2~7#01uajBm-M{&AA` zEo@SfTx82@QP|_22HTt*q;z$ZRObSj#{BUkubFAYUi}K=b5MVF14%qpB&&0Rkk0Y# z^V2j;WUVIPWqsN7^^bH=1)=gXa)qbU5ZQt{a&M)i(l0etOP`WKdR#e`hGEp4eL@<@ z?#hMo?>zRW^om9d^Td0P%O#J*+`41`<+*F{{<EEg|QU1cz9B4ZwFpngmr zQbQW{kH|$I@~1)Zza^n-Ft%OiIK%b0BGL+dwuhKQcs?ulN9Day_(R@s;~Xn|+wy*+ zMsurIAaYleBc99OD<=ohX)dy6(I2_DH4r5`aV%k+K&JA(D$Voht>*K-g8XcDeOc*H zEQeW_In{*q4D#9sBXV)IR|AP@QXuO+0#J>gAJ1{`#vv=d{p~8x%N0wR3LLk8)BiM+ zymo6VUcp_0$0=~$f&LP&qtI`08oF?tjLMFa>kmDU+n7D;V!#`&Q(i8i4_zhlM4P?v zHgFM6oH0UIhy57KY*h+o?> z;pM{h#F;o5OAc|kB^=#0(l@OfdB*29ytTy3fp_$0vXPHFMZdg(%oTlU!~N#5^4A?D zZdM9s{vCOo>C{el*-$v|fDEM%WA!78z-(d+t)GdYOdG<7#L8BXI}4$g67^m;@{E&8 zE7a^Nk}2!S_hr#vvKxJlu4kea=kYa~{qpjJCw-$La4XXQ|B;!nY@|<|bDY>+^v12n zVR(Oz++|t%^i|sI9+duXCuh*sk2J@)cHqjvoG9-5{w zhq`0Dj3tlLg73d$&+MO6`oxiU+sQnqyQ94^*C8C+2a$W|KyI-&*Mhcv@|wO^dve0j zw7db!cs{?j<{D!i`!T2sWH|A*~5O|P3cVhD zW3T+R(Hm>xxaQ&cxuvEr(`g$v)91^RdA>g_VQ9CXdBi*qr{n1>7r0MC4PMl(!{KV8 zpVZ?FJUwT_xAa)~aM%lf=7nQA*N+PhWoz9=TqeKQ?UghWH#7W<-%#TuXtxOH2%Wt0lvgD*b#>;$_7uxTNV8154 zr}}5&KtJjN)#Ajvv?u3>aD>!IL>jrOp5>T%@o2wf?BRJB%3NA%^M8%bfFh826aH~> zdY3m&c498=#Y8*=wfULMN%uC$`bXpzYtt*C3;D_u8Q40I>;8HNq{MtL_{1-SUj*}@ zxo7$5&wYwtoFupY?|zQJg~s&X{6P+Jm<=Ny#!I5X19xsmU}-*c#;<0g^jsUP1u1fH$rd2X74HciO+hQ~^p!ULU(BJgMhx!UI$ zSpLI?cI1C=Z}CLMaf@)Q7wZ>W={s3yL+6|XDRa^r?iClo(2ie!P5*>k8|tuL^?fCM z8^ms!*3To2TSM_f#Q| z{DL{-W%tQ0@;Ax-UfFSOW&lp&#PYV)&e;zke$) z%<3GD_zld>;@8cIUl7XXJ6zV44@p6teuD}=cZDc(r_;m(u z@%S%{PLPymp6GKrj9yFJ!v$wx=qMY4nD=c*e((u7)`2S%vFiwP+xhv8N5{)_@~VT5 zMquX=>Tv&Npw-o4_B6&zRz2n{FVe!+n)R728TjR@PqcE&3$35Y99BUf3arM%7#BnDy|)eKuCX#`7JI|` zL?HFH0Tu3Lz_T%V;f=AP9qfhaY8_@T;dsUSJj2BCs$jotbnvD>j}|q9$diVUPvRcV z&uhOtyz0*WNan7cNQC}d1}2bO9Cd|0EHAwkxt+S&!S;uJ=eL)R3(fCtelRnw!@T*#i*^-4j-GM&Jhshl`s?&&O}b`@ z1Uarul+yn6Vhl)lNzEKHDPMF+%>_f{A8cxHnpilTI)v>(UJbB>1_=95LFU!&?l zf|U3X&y0sSITMg5<=9()teBi+g(O+kDqe1WAQ$PIDB<}=iR0&HG(9Yf>FG0Tt3e{E zKNx!_Nxyjs(&C*#s&Fi7_DG3ELwt~C$DE_dDsUI-2eGNPt{MHhYBOmX*2bPs#+YQ zM`OR%E36IDgN8kvRt3ZqI&$ECbH-`}&Px zPp;005$6n0tY9B%H6!l2u`aEmXMmdlhsZd-AN@c1UU6s1N`B>M9X8EsVv(?f&nkvCjpbm6>GaRW1* zBFTf_XYN&(44hJ&GimJfy>o0_nD0ftS>JW)|474@-eVGw3JRLV+gik6aXAB+Ww< z7(IhABD-*S@kpN~l56`=&3y$88`zaJa|* zEx}M}_^QG@#HN9$`$YqffFNvM6#~Cc%)gD~p_dLl7g-ly_JDoCJ;_rguy2^PkcMaIk93gSV`w^> zEK9@rJFG*Pm<4f*pEZE&!87_O=~+)In}?~a(G1^6-QSb?TshX#9j$n@){2{~Db;9B zjjtYk8+EL=v!=XxWiGP)m_KdHLGgO-cd6;ErVh2bBQpv&SYdOdwnd%hELnk&s?5Um zv0@AN;||rV_#8l9OPPm?_4BYWoE{er^lU0gUx#D4XyD5l2=cIdv$w=`U~gN3N>-2o zejCQ;=eoBHobDvn(H^pSwU>NaO+Tk++}AE?EXO9hNsBS=GO%17Y3JZ6Q`49k-AE+| zCc29sH9Xe`4W+o0pG;ipB4q;|#lB@jDP7Z5q$~5KqgA5)%SUpUXC10l$+s{s`8Sza zla2gkZ4*D4mBr6t&))GM>HJfaIYm;DiKC`V9>>pw-ShR-Pjs`czGo!>l816|y zxXeDxY&Ch0pM3s4@;T85G5bk_j@y`bGn1KFjYHt!&*v~X7ku%q+?E^dudx$7^jgMnBi%-dgItU zo!&2e-nRdwPDgFBEuXjV(PRu~rDNg@3$|BE$9|V|vLqH9+R0p#@HBkOXTC$a1^$Wb zBd&ZF>sMRwdO#YIhgwkQEbE0@dY_Kxvq>EzjQ^*;o5mhk))iIk-ygz^yno3N9pJMR z$!BO4Sw}u+q2z>*yd_V3j-IL)EQonc&zXF($o1%#NK7C9-kWFNLO;L_DHr7Tx z%Fv6Hb--Y1UNJja-};e@**C24+Rltdj~r6%}1 z7b{QXBJNBse2$V|9B+loKUS>YO@4STS;jrgww}!Ac>sM%no^7OBG2;aKDLuc|HILk=PB~t|V!qINOZ!>*uI8Cn8m5*QaNS&Qr>gySlfJ#_=*D(KvMZT` zeDlnqt$kB1|2mo-YTYoOu4&(XcE!KVqo_{R zl9|!I^FmIPH|}3kqLzj=zEE-^1p;dNpq1KCEtt7B^l* z;BDUsGzldi`IG)CeDzf5aNfoo>XpnWX{p7tAIzFKtA#!HI7cVa3uXj!K9}>oCCCK* zOoVMR^Pb;vEyy~Po|?)&t^qI4GNOJH1Cp*8kg~~yDU0dLScQJx+*?*KQ1{{*Z~I#M zE1oexRo;XN+ymF<*W4zu7w`+$o2`xbc+r4>^+pUEM%|(g*M`(_-aD{YMoZ3-YtAx1 z3@FR`WCY(o%3#8^czQhsWaAgtY&~{zy>>4XtEOjS&;+j8&a>ZTHS3duGg03?3!{#( z2KJVo-9|DT+*_8eNY1f6dqY|Cy)h{hi@25?=fzCf5@du9vv-#J=Ue>$rGA-+b;w3X zuK#W|&%(pS%%!fHg;q-HP8Mp5Ls*k#ZFYTf7QlMsfBU!pUQg{jWKR(1m+AD>?x7<0 zt`h$Pp0d+Jfrk%SA2HgYx~2r0^dkdC{wveKvAT$Uh*28)8-!rQFAWOTX<$!HIQl8a z!K=}Doxy&KylBi?7mbS7=>yC0t((?D-)#%}e^190e`aRV(<*3RE?O+IB8=mQ%M;G+ z@yzXnpOo-wB2y!LCHJbIIBa58W&=MdwU50183jHzvqMSh!T+r#jm*HFdpii*4lx(A z30d|)4OXuX!NJ|ZFf5HGOGxJ7F#QL|(aY(tEojIwJ$11K_D$(G$g%Hp4{~UQWGs^{ z$oNd}0**V6{5kK(z~zy~_@Nrt?@%*r9hvUa!#_lt`dgamWCKHVVO=3n8e; zdCZ=#{y(A+MUJOkbTs=T$?m_QXVYN%ZLPH+cr1JP3I@FB?b(*Oro3L`Yx5YwqH&eX&ZnvD#ksNthsjyqq&HgHF3yz;)6ru$*Of~- zPkNE(;TkR9^8@N=xTfouhX{HzUOttF4tKp}LfPgLX!eoe_gY9z_K&o;c}d5br=SGQgOp;gh z>Rq`hNnXr0N{!(OQa;KDrQLk7_`V8b(tWV&tqRj~l=z^~!ihBjpHQ+O2|AR64vABA zm@&$TWw(szIM|4}9M`_JHDY87=HAa`A3OOE1O1!aZe`)s4EncL&%)IOE;G_g~k9&C_j9}}fGElHaFW>#jGBx(N6BweF@a9QIE+jSq9zp0>F>_fK5 z2U!{&rp?o0*`NsgY@|c~$;_e*;`p1*{WZtFN#p59OE$cW&43lX=;Oq3C;J9_e9vX0 z+JkJgo==W?8vSOq3iZFs6zVQb?bIXhku%_*J0J3E8lyxzn5d;BNuS9^G0!(j=^%r2 ztww$@i&+yk6?TqQq1j&gBetgp*Fw%M-t2AUIKSyCvm!V@jHgy#>KOUTXB@{r7|4bh zF}pg)-j3u9j*|Zlqo3_fj+c(vC`aDmE%Qxpj8UlH&||C0UWIyi5`71q?bME03Uzu7 zvLH`P^1a9?R)3QmrQcS|X9lV6sX}(R3JsmfI9&3ee+siCvX(qgRaYh9S0&C(Q>b5jH)7KqdPh?CIAWmAP&*41 zdG9RX+>yLK3+^Mb5ud404_aZTzR7EKlz*Q=|HxYj3Ux#FU#!_e{?%|$@}DG0nV3T| z_2xm*y;mY#--zC@^wsR#2%6?x6EyI_p%FS^sazq)__iHlGl)A?uer?ZkYL`%`KX@tBg_n6evGm$v{mXRL zL*hpHiE2UiEi^#JuTwTqh@4;C_aC;P3Pk zzr{7~6)Ud%Wbd4g8F|;)6UTkq0rG>V^XL;fUnz>V{!)Ffj})dTuzIf@3ai;eQA&Y? zm3Al|WRt7MLU5+@0Q7he1P?N4XIh3pTP+0rr}22+(#Po(xo++q`Zv{M<9hZ8Y~p(T z6!#2yoJUWjV_!0}g11_5lXK^Q#a0B;e{kgb57@=|HJW4eH+nIua=BOC)>snG_{sd4 ze$w-YN>Vs~Mh#NH|6P$Jne6ePwgNY1(?4=MvnL8Q`0)98^Z_fDuKj?@ zR?es6eWX^3uiP)~DaTDsr1Cp&i73I|K592by%jj}LV*USi=^p!dujxBxEMy3k#p(w zLe5>uAt*a_0F>DpjCG5~NRG!j1390s?vWJkMJ1x7PdbH*2{>CJEureO>1| z=lssz3g)b7AbLCq#4$hq{93#w9hmd>(WAvKJpya!p*q0YOKr|? z{I;NoIpKftJ}=yYrL1W@J;~gTXN}Nka#ZK7$l%#5#26=~h8~iSPZGqxyh#Qn9+bE2 z)jVFpoS-B%-fwupsj(*(1$n~aN1c{WI+QKPGr8Yl>UKn+Rx@hncHo*{WI|pgGqo() z1KdaLLDp-BE-+KunzhYStexJ?K;^vl1R3W`9PDrW3w z9K9HBgq3kDp&MDtBPI-Cyjs;f3q#vxVy9Oo6r7{4mq!l%5PN~1^sT#1{mQ9!8g&@= zX2y%L#spb&I9_zI2c=7_L8j>vrBs&$8O#2}lVd8pHmgy=o3Zo2P)jdm7#8saeL1UCi$)E@gZ_OrNILWKUc1 ze%_XehhH+Gr{4bi1(|4`OHEA!<2yOV;9!MjGx^*n)Qe0Yqx-x6|Hm`>T&^XvRu{@r zC+dH3KDPch)_Rs^qhIC5@_QV0$_Dr&upRa6o}^%uQw~nfb(8hC*Ba12XMQ$p+w03@@;Hr0 zQ?dMFBuacuMW@x|Xo~8}{E5Xft`E7J?opU9ITZtHQGc+ho0Q<=>(!z^N>CJ5c231^ zSP}8gS+3v8lczoW(PDZOf@0`joS%&@b85-@)zlo|-2b~yQE2@x1t*I*v%1SgW}GRO z-Q>S+4v(fc2mOA|Sdmbm6xRfDQvT$yg2|nc>zop6#g+tj@u~SoQtxpVYDXmg2~WZD znpSM+dWAd`SOK6 zwqMHW@w_JImk-e=x~_|~^Zz4_s0a6OWEArT3;u3OZR2@r8OoY1vsXCu)8mdy8rrd5 z-RhpR47vSB&ir9c=b*=o&=hq4n2l>{XKA`GU(`xJq&<$pkM^8-F8T;fbR!x4f;tWj zeNo2{g=_6upJ%S!xVBOb*DREME0{kY<@w@CDozwwG3q`!&3Q#K|Gh8%sU3x*nPlD> z2YTLYBBhdxWED9n(?#;Cc^1Ug%E8_Nj#9(3K&)p2v132`231oLqO?L0Qb#mxi=<}T z09ZOiK@O#$j63V_DUBqT{=Xv|`r+`0D45AZm17O@J=D^&pipYB^+$&R%(<#?o{n7M zC-$vYarXYgZ1TCAqtPjW+*S=K&DQ*Z7N z@57{w6h!s3BJ4&(sY>7EzB)fRI&X$k)(C?#kSc|==41Wl{u?jTU}r7<`$6|CXYFu_f-sa469|M?nYNBX!?h~=Yjb0 zBnoR8Q|q0z!fRbaNysP?bp-V;UXfe;l7c?T*;p1|PnK*ckkee(b#gaj@(S{6&B+(1 zxXH?ktj{}9U$RFO9N(s(bVxRyY<7|y`j-vo{r0X^6#TuYqsQyxKfqZ6>3ue6nlBPs zvfgn#1)igWr|-%Fh1q-pF$j=jZQ@w8GZKQF^Z|mZUnqP;xzXFQzYfMm8$! zXe`-nsA2HQA6ptnVc+T$6lG;&_}d0D=175*t?7>j{JC2;r;`28#^5iUN%1U_s}bag zS=YAfN)L`iD~@Nl%Z719Vo3Fc!vykl6D>fw986Akl^)ZJq;>=H)J@2ZHfK$`d^VoV zca-}vHksw_kKU8GzdcOBq@UUJ_oydBHj9R3qo;KRFt)FUSSopx$Djn^+IzNmcqpZ!X7qNd-M8(yVAO z)=5^(vB{?30F<~Ih22xQ?=9eZzvv>~zl!DW=YCic!F*s|3WmJS#>cvi<=Vr1X_xDd zDcm=D=BFUDi4~PMILT?pVyXGb4-0ovdt@;AKjst9-Tuiymwe{zu!>QrhJ$jiJ8kQF5{eB9XZ}6(xAxW~x8z-?VJg|!TUy;?Q z>$fQ#KT?XR-5D?I$t4}U7LFq$47j-?9mBrZpgKsMfYM5gR#I1qyj8Du8OT3ogPkc} zI=xmRe^VIBttBt>ki6b<8;Tyq$Vl>NEvZ*nvAU6ZM(J3+g8tEE;$^5kHKBUw@O^_3 zb=){hH`>N}W4sjB=lp+a80>@TmssSB{ZQaF|kmsrqEAP6Kmuwb}HH(bc z$?NvKB+mv5$Zt|_uJCC%e2Ws`RE8YWL;B46CrITD?uf2NJ-#Ti41+S@z})C4CzTf+1K&XIK~}s8inCacj~)s zc!0F6^qao5Pab|y!lxm9ll?jWeG`ag9f_t(J0S*>(*tD(@m-B0A2EL-!6S+JGhXirH=Yd_Ex2#z}j#WV| zC-QW06**_ZvzOESF!Wnu!1`$Z+%ELneH$kiFSw&PN{iDm)P?j(=b6KXGvNvHiuYR& z`j5~1%Y?r3$dk6G|17Wb_9727<^AUCXv7#D{lr@+G@j(7l%=SzSBgHNSLpjZBNNLf z*)aA(g4A{Lz_IPr%$jb1`=xYLT16k{c?aa(d@?jU!*T100Y`bAGglNNhdx{H={Nn@ z5X!k410tGGFYg6?gm+S>^0yj22a|(i{eRpN>eDfYsZ%>%u02y?!d@-fjApN46uDh1 z*F_?~&mPOc@8S3sXheSX4D@&BnfX<${G6`h8C!>o9Sm4Eh5DYnKlh)Gl{(bZTnj=bF(ns9 zf8OTPl}Ip`XC0+b|uCXOSm870*7J67HYL{e{v8 zd}aokF~4}$B9^(RJKo!cqhBNTWhSKKZ4=H>{f?Cbylz(}P%~|x0Xve?akeej9e-}} zZ592H$n7p>|A+kD=X@J_%}fwIea4@xr#Eb4Bl@38$L?;-5$MC#b0T|SYHDI+8Zc}c z^Fh`MHP>V1!Xyd&v!S?OtQ=oSJ<8HL@*?zB2$Q|$mG1w1CrObT99mO>YIH3$&pS@y0%GEHRY3> z<|vcrZd{NuteG}BxnZy5i=E4*s56@-D}tA$e0lOS`SG3&Nh9qBr(7I(A$h~hnaOuI z$4ZGs^c1`qD@ibC*rk2UO*Oi(M{S~a)Z{8;60It@KlH$w%Ur)?94#%CXcMhO zqX{bXXs)8pA8S8@`P^e_(-Sx%XvnN8>@8aW=Bn(QuKaq z!To!|agh4LW1sAIJlepZJIlXPgkdH@+mL@GmWTyf;A`B z;=Vev*3{I9;cl#fJvYL=qv3z%Ia-X!K>4v`8EcSLXI&#Ui{63zsGrDQ@((|9i4LsI zvu>xmn~p~>(-AU^yd(d9HJBcOx3duai#4JO>^+lbJi+sbS3GO_`P6V2!P?rR4BQ`+ z!CqQAy2NB)G@l#yj+#BqGEkNMkun>&&!us0Har7&lQK~Ej*IB;ImwSNu3|0YD#KU0 zN#21blF_J<^kiT5YK&SQ{PdQ&SJcvgjNBnP8WI5rm5`S;4FzBT}5+EB?*JvrQSUk8C6Fq?>;!lGkWA+iB-#4 z7YF&Z-9;+pJIm(CB3VO^TBBQ`oS`nk@Q`BJZzz;@T?(X6WBTT#70RAlHreY{B(}K< z6k3bqpGE9NC~Y!vK%unKu^+IZP}<}cigtnm_dh6bxV$|=J}I#6G3yHS*s!G1r-J%( zBO(?5ovAS84D-%kHmN*90sXf^3Gq^(^qT_doKPfNE(IWOus=pJKPf&>K5;y2!Ulgd z=^BWLqXCHP?~nIc0VrKJ2-UUzD0?LkZ6C7Vxh?>Q9+Q8h4t~h10Muc9X!XqieNq_81qD~$A7-w6MZ~WxTdCUM9 zILo$AP3^W2dX1bUd*~aDi-XA-DyStlPmf>6qTrB8Kk2biP%*D>yOTL2^R|ktjWjew z!}CKlCasP}ZT=~`7KP)7sU6pbeB!Za+-5#r4fL+c(PL~A=6a9xIJlRyf3KN$vuE>t zD4$cCen}tc$J?Dcb6+E|ZF(y1>?8Z6BU|`4X9Vk8uwt|YONORmeFY1()>83r9ri7L zrg9dBnoA=r_{u(pIW+|r@>4NA%Ys!g7JRS3{y6(BD?U+Uj(y+{tf6=QmJLYa*&Gai^&8%Jx_GVsKVBu>X{=gYx>IlTSrJ;KN92mY?acuy5B6q2w$o_hZ zU1XsW=;aY(rS36v#mK8&PSh4Xr*{ne7E7~~kdLS32s^lWji+%8s^r|*c zd#M_k$mu!Qv4LJ;Q?2OV&x$>)DQvl5#r%8pHrPcy$FVt>$J%~l{@mn|IXK!i2cgc? zbUf=O$A`H~-c+*#&P?;^Bbz7)2zM>5yU&pG5PjMTUA<~--pLdmaX z2mA8meA^dG^l6*etuL0h3I%6j6zH(Y4(@jq@LI1xzdzJ2YLh4WM$|Q}Xp^(;xW-!2 z6NAr9=4|c+YEbpz_h!^5AK8zdp9u=sA0vZ&%_bEdDA4nu0&DqCY^egk!qnB?K z`|<3T?TNyucGTM7bL;w%0nQ`GxQrU8>@)7QM8S*eZp5!>{MDA6%5&!YW%QVMjWv_y z>_K*9Pn2tGq#I{fE9h})Ai2imC^TIfg<2`pgd~TU*ns`E{4~s8U_oXF3)1GZCee=b z&2=rvi{jk-u2lMHTJU@bXOex%D(f zaUQljHC*_5e~nJVdnMV%0T${yat(h=)jrh8KIOmAPj2bFFOsI~SIAIoKU-#f$n@tg6n}pJ+vaFV_;+)`LA($RsOnb>M4! zwBpiKYB}<~e7%{`Az-s2<^!dOq2wl^_mUgBHBb3E&YbMjvs?0`1@6hG z7tBts!L^&myc=i$|o-+kZEL1)n?SAO_7xpVtEDK#d2 zOty?Kl`^V1=YygXP0$S+E~R2pZNu4Eoh)-j87 zhCv2s4bpXQf|#cpr2O4D>CIVJyN|Jwc+4OzwkZ*7@WAnr*8l`J-Duf!`MlF1J#_QfdOCOCeG!53$ z8%hVuSuIvZ=ul&m7RL&-_^sqwbNqj2K+e3((4j{Y9qO#qqTj#aXy29dGv1t6OxNK{ zNqSm$3d7LP;b`?M9Org%Mp(yuMMux+_S8y@CjY~FPT6woJ#98(?KJ~3qsZipFyYY` z)`ggJW_eP(it{PGa;P)LTGXQ)o-G57a9U+XZ!L37o-v;C8otus|tmia~qj&XRnF!yXfdOALAScuRFV9#q z%t^=yN*ejLlmXqEQP0j(e!ni35j<->NGpLq<`NkBnS1_=BAG!x@Aa?%OjyD5 z(ruL<8R#bI2Nm{NcRG7y4rIJx%VEhIQPFAC^tSu~=&Uz2Z6L1{syZJaUb~bt5myJ?10z zPP@zWhArjR-`=vblS+!c?Qyx49hPYAF_&kU;s*BEI^8B|C414py|Jx`$-mqR0bZFN7S?|c}R)!j8B`Vdt&<_YW*GZ#IAdu@UFz!M%DwS*VAFf z3LXBQ%=gkmhxskcs58oh3*qF>gP7ZICmY8cKZN_@kwxSSoHMa~DRs9hX2S6+wQYYZ zG|&CXf>0MRX{kcfhQ6j1?Cdmn9xtEU7-bh{OskYN%f{A+1dq*9zN3ngJJd1u@kCD( z*_{KP2so@lLBqw^U7*95<2u}MqBdfV4t{&cGfrWhz`)OF9(x+Bzu9`4&|hPQ*P%?* zKc9)IE$OSepKN-Uhd39Rg+b(XG*ftudMPwLsf{?a1K$hvwr=^GrQPpDxvn-#(9r}r z{qm4FbvMi77Mv%zq(4(9%IJ2A%Klt}HGv5R2 zr#Bj~ZZeK_-7VCy+(zAE)*BMXl4D$(iK^t^UF&Dz%4D*!aSDykOogTl-_OS{3eE9X zyhdbJ4quO#O(o6JkDlqh{~VI?pUsloJW<434dFRtdXXAAFVtAaI@5jn3w=JxIM4gI zVJkPPIN->41CAEyF^k3m2D`$Jj`$J8n?-R~5?x&Wo zPYE1ZYLELp6gV4YhueevF{TppkS65Oih^Kae!uvB05)IMqdsHTl(N)aueJpT67*k>k$K5nlqmM48S-9Q^P$F zLmkO3au0m|I2suh^>93|hf=M_vwr6hxFrp?%H%3NIakO$dHlRIbmH0Dt9~wA{!kCG zUM?1X&Or|M?1lH4Q}od0a2z?iXi7&5#Bo(v%SzL}h5 zr$7vh48Yh~L0Gvt5C=8~;K4G^m37tQY(8rRS^sf_di)!zM?rZ#J@3=7`Jx4nn2&hp zTTme)4L8=NVf#tyyB9N0p3FRfI*lt2@as7_xLd!mjJf0`&7++qWt^A13Gk7?wr=7& zM}bvaI2*^>PXS8c`xXWMx?U`^_tX30Z4frFW-=r&7^%yshq#IQ`^Tx>`$~@$)0oHc zT3IWT5t*?C)%U02VAy%gJ!pYvW3r6)=h4YK4Gzg<7@u2_?wpHTNx7)KB^RH%e}cKT ztAtJRmO7_hL|Li1bZg)()+SBm6!Y5>QS|nxXpe%Yye^q`@MWL)uh2j&-WZ7E^#jp) zQ2_V&AnLjW;VEP2w@Xpz*M~KiMO$!oksc54QCDb@1(*4GP5Me*U)D;F@3J5;kF^jB zwWz1$qF-hXY{PRAW@D`)oG~NGO@82Jv_$E^XtR)4Hg1z=d9KP>;U7tf!a&l=JBC()RER?i$&kKLc6ai%3T z{QFpNHix=WmQ>uTnMR*^`f@9B(PIGpRohYX=_I*?Nx5+CmxDpnuRHqNC`%F!%EE#} zGIWPo4qT>ZnV!Ab2<|}@J@MB|6>CQ-*e)ocu1n_q0nhhk=(Tf_e4I0NeY-^9`~Wkq z4>n_KGBwM2{yw5L!}}L?S^e2poSTJ;Q|L9rbM4X3)b~Be^?yvE*}(m83}ePCa$jr6 z$+cuGtHRvKu2h0NjW$Y753@u}rT0;5v)qdz``$^7);?+s{o4~yo~TiAi5Cv!Yhk^n zMOsfSG#wTr@(*K1ypGyyW<+_KG5HU@cj9?|KSPZap7WO<$RyYBzq-P2K5=fmNfw?Q zr9L|M!{VO`&7Zdl&134s7JO7_KJQj&A~WJ-c^dUAQ_Qkw*deLqa8x|28>My)vUy`Y z(SUXP!<-ce*v96Pa}zip z=cB{%wVV%NzdLzZ1j7E+p@B~XCbgl4z+!qXonvi&JZC6&n_%c5sS0^JuVG?j)@zxTUBlQT=9xyEbb!}$7bs8K39nq+<%lbk18*>|K_F1awD z-|U5A>JokbSB05tRq(Q^@nDlDs&1xs!zbz-Pv<%4I(4BL>)&kCQOCxJ^8wWIuVKQ{ znT%Z*sE4qZ*NA70g{;57Jxfma0dp_rciQ{R+1OL>Yfxxf{j?!)5B&pq=BPMd@jtpC z|IL+6_~0xrISX9oIP1eF>6_Dzypq2ax}yyxggS$Js4F*lV-zCPspuU|cK)2J)SK}~ zqN$&lQkGsln^UNhpN;bioaK9oKQfHmS=S>xzZRz8SEU@xndB;Yh9W8G%srwTYgNt2 z@BC$jrj?U)UtA#NlBws#*Xgz}6;8jcFe_Z7J-M)rBm8hu8-?{fENFAzit(xSrP1mF zxqZP8`iv+v)U&2khcm3yMY#F(kNDK}MZ<^DSRTMREnh2VQX0yOPzCBe8HDChktjbZ z6@l60aTby5vHX$0o6_gkL|wvtsd(?hdJ`H-vkrxVdem`uBfsOHiu*muF%6~P^rK?g z^uV7z^eBwEpUU`Tg-a^^qp$yxUNr}y+UrR4DV2&bD%PFqHk1Wz^F=Y&5BWyUC$nCy znwf*9Z{4MR#vf_j$`2b?L}3PNY*RK^5&4wbyb}tg+;o3r)gl+^&beULgmnwa_vQT& zH}0wGiS*b0Mt{|v*_e^wB(=%kt*P#Z6L;yiTgrl4z4DCe%r6e>59Isk6DaS)s%zS^r!_9l*ELuiQ@m>$k2lbZN1q2hmq|4(AFh z^E%I`e|KX?**G&_)=(dF|MN)TQ3~o;rvL2KCUS!QvyEp5V2Xmejf@HHb=i1xzM*7K zA@^4}2$AHxEX%0}x-FX;YV{<&AWzODkTYf9ATOD*gZ$?EgNu`qddjn~im@h37{88{A3Ni*P|qLzbi z8pc+ouEG1pvaVmD93MwNtn<{^u0?&leO8o?Y$#i)g|X+gFX~o}g3qK>6pyyz{&)7t z$P2G}HVBDZqHy3SdC!`B|NR=vOX}+_@$p6Pa#0w^dab1%XRfz8%jGdP>B5?IdM(z1 zO%^QfPCmD%ql|Pe7N-g1DBDCMkY}^GT)zP)8i`g{D3@yZVR>)Xo)=M%a!WSW-)SOK z+WnDzXMJJ(LjQN34JM7CF5XgiIhC6)GT)E6IBUiGEXXCldEk8`iMn1Ot#YYvI3x-W zf2MFAiXJ$b^<~nge7UliuYZ%A?_ugHeq$eFj)RQ*@<;Y3`JvAw@}!-4KM!Kvwpjyd zTv#ZV$w7DQPoCF_HRkErs5Hb?VmlSef^z;yIgZpQne zDY?ZLR`h%2B*mY8%jb5!^lae%5XbuRaQbC!Z!BeA{SnEHxv6EnWzTD?o?jHkxuj&?@3ACceJ_o5f%qBkXIA6pX zzu(DJBsf@MEaf7uvkGNJM_=@`(AVCQg2lYf%^o(A@i7H5c~t-gg8X<<3Tk(xPU4Hk zlDQ&ZOyq)-L!&UIANyPHvT@*ALm646NT!hQzQSI>`1TeIcD165wT3L??{#K4bt zd!d8{UGLEUoxj)6m(&lfKrgE1QJC}(KNs?+lUp^CYajBY5%)=*54l3di#?mzw~BI- z`x$xiy^=r5&F6KPk;+*v6X<^=%(onI|?BcWPpomiuDL$S6!Df9ijVT<83F zX}3p-cL>A9U;`Zd(lKF~4VACP%I-5tG^6ir5_!XPa|V)%Y^=A%iyt|%wz1TYb2Z|` zde$Tvql3uNw6=O+a9k)>vHseu1AS-6odumSNp%IalgpD&Ni$;oxpb)NDl~POn>V@T zflFiv;>H=U?P@xE@;2t!vC_S&inX0kOy6Wc+HdkTgB6;5Q=A;#;sy)r&M$7$gHfN3 zCK{fbsQ-1Z7UTcWP+Vl4`1ob&cCEAFYX5kdQqrA1tkh?kM_t7c8F)jEX}d>^ykF>s zG7jMgwIyIjL^?|F_xkbIe)%|xdVjfLP@bZXD*2|b=Zj(E+~%EQYV2$ij)#@$ACZuO zoM;>FmZiSiL^n9L4~6w#`f*3oKO)hFF64K-cer9TA73%Rh=b2E@MI3_0rX4ltz;cu z8A`7g12(ltM`2BcX6uz0`SZgaOKWNo)X#vryVA*y+u)ZMCq4U<4zsYWw^eNmxF2U=zkQkRXqo6#>$7C-QSn!M6o*77ws$;mp| zpzw~B2V`LCW|Bh@avYb^@qVcdiJmc%Hj`deueB&S$B3v{a(2IpG2?igD5$U3VVo9@ z76a$iGq9|sLgT(XMmAMd(!W*4&VR+Tu2){CXeR6FZ^5bPVdC4&!wV3WU7gUZ-aUI`ICCyiCs2 z(GBjrK1;a1&i18eDBov?2C>qTI%rin(-lm1rJxgix?L2Sj@J{Uu&oEeABJJ|Sk5OG zb6xl;Gw{ZEsc0Si1WGkY}jxoLAp>o z?Z?0{l(|d4?6dT1_El&mP~WiTM6M&X7R!DmAep?%r_c0BpBX1@FHsM)e;B&dp+EJC zbZT=dG}Y?GN$z?jdM?-EiiX@P@52YZ$rsO|5A|0M6qv{xKB50=opf@O#n{Hrr7iV2 zE)CQor=tG12veIqnhs*;zg?av++_mjqXv-V5gA@aQE zwOG8DZ>XDM2v?z2Vi;ykrRNy$t0Vlq()oEE?#|xd{7|f4MgQ7S+@HxO zj_p9-x6|~a|0f(bzZmfM1oFtRp=n;M96sre*wbNH$Ir#qfnHzXHdHwlE7SQt+m_Ix z3Ui=alc}?2wV~#e7`ac*+Ct9ypRoo^c%1>2qYcZb+k21q!(!G0;>oeD;5uz~oO-zT z;^f&M4{V^G=FkxK)p(yIaCY&<6zVPZal^U^;i%Nf0Q0|$7d;f3_G4mX&R)U`MLo7WSzZka{ z#z}fpC0@u$Gp@}=2m(wWaQm5w0{-gl* zy1!5M+i@fLYe%<~^$%0dPD^RjY3me+PNyWWQ`iAxhrah0C(qD2rj+%&m^{AC$xff& zs#6-hsnw}xxp~RT@4ZrbE1IMXTQ;&&2iK^MWu40>pK!f$PFmMZDV@3JT!RY-<(hwj zJYX%NP2~jf$chzTY8kvfW0u5?28kuld+>`<6z2>w<`I3Ss~M#F5~J+vVvrJ!2ANql zUY3+hkl#sWxt?v7!lwoq$614bEnN4U6&O99uhqvOFZrA$WN80fjFYL%^{lh^(YWsdGvMYuR_Mq{8Sa>>tliVQFvrGbGVJ z@HusZkI;j9vI@h=zV`}d{Hjhicn)IruqyZS4_b`P zCWCmM`~5E?=G0_eL2tz0Gfc4iM2+6X^s)cjfO{?I@1!(QXP>?8Ek-!*HzIBuV+Z5h zGVZknyN&4hg={d{#oW_I>KYmGo6l*R$(ht6CZuz{zGjRVK97&R%bHg|a*geb@F^f8 z`P+zLN$ht&HsVDs6SlX{#Ev-n{%vJH=@!3UMb6O3J#uFT$~~nfBRS?Ol8IiUGBDaB z16HoP!=KYJW@b8^hGxJqkLRt&=_ngX-k#I1QeyOq4TIDJ;N2}#hS$7Hh z9_UnqLyt~mra&!6GIV#4^CQ`%XCUZ-BisvPz{2b4GXN;$)YH@Bb z(@Az!E0%{Hi{&*L#-}BV#p{#;>am>D(^D6KU-zU(fNJv}N#9;54c2n5Y^ws=1@?%n zVw3sw#pSFvbAuvz<8H_MfczC_oRpCYGORXfKFKEfQN^-(0cZQ$D)6B{b^i^;a!pq( z_vYGUtCDk46YLOJ$0m(_{t*|20{tBVP>Q);wGRQf-i|X-ul?}4RsiPtvNk-~A4BNF zFs*GM9z62H`Q7xKULHuVr9j-%2Ev^0kEw40@bHj7b&=>DZ3;lI0f9KlT8Nya*K`ek z@=u)G9PN+AFX(rXNl$7^02;7Qp{`180Xu)zhUlA7m$R?W{o&(5kEhL17*vIfVn7u7 z%!o!DbC+-Ao=N;(f=t$khA5l1?ipJgh(VXYx{Mc-ISFmq?D~+Dftn*xK zL5|AwpZ202HQQ2uu0H$2qoQ%vpI#6HqS539Yf!1tSj^lpNxcPo`S>&4_4vWsMbRhn zUbCWc^Jx@ywOBV8!#*j2rw zsc65QJ?E#XILBV^05XiPnKvC~pI#BnUOiuQn5P7g1&QDci(Tpsc9CJWZi%0ZqDO=psyh7|1R}&Fm*S3NUk|p5ND-N zwH4=Qvrco2H51nRQZAEgEXAG*bGD=ttj}wyCs#Wc8_5aO;-7E1oCzI9O{f8^4W7+` z<}GvIDArYya?p&uppon^e1B%e@AWx27iPuHpj;fB%U=E~D*|g%)3LLU?7HJ1Tka`k zYNWHgUFjl)aUPOLUDPV0=-tp*EjmvhdD~hof5m%B%OjqWq-rANH#^IP9Vp*-#mmpC3@OSU2K!1oLL+;n;H>g z?2x*KOk}7{`cu<3K1TbDgy1nuzd6vyOq-srJW-Za@Un3Lc0J&1tfL>+UZh8L$pCs0`Jst(0JNNu#5(FwkxTy3D*#o7`l0PUfBYIt zUC12HmcHUWUzN3#73}qpVZ70bzCJF<8nPty6ItQ6pcFXIrGTJ%U$X`a;=#^MX6u{DUnagw8l0<6j@-1h)1H-AlTwy%O<8wyO;T0&DxKCQ-%kGb zYo(Oc$6Y#?e7!iSZJClOz1N&i(mYH*7doq6^7sCe&b`&_Noo~XCS_#6gQPwUOtQih zD;s_qWNrvOL!Yo`)YK$ZK2wu%cZ`5%$JPHBq)8^vZyyb!Y(Ouo-DdHk&QtE1SaIGI zBdgaMU3^UPli%MxEMA(h_mU7FBWqe4 zW%lk^>Kw;OrXgO=d^5>21!r5|DzUV`n*1H-y6B}a>AjMBD|NMlRLFm$M1TYR9*k-{ zcT?dv^+F1r)CgL{=kcsKcZU)OBY7??=2>qMHMx1-a~rF|WQ`il$}lgit48=1CH)*! z*yE#yay9)eIcN2UuNggobA>1Pycg`%o#f1#LXFHH;n=7lo2b>oM%M6DpceJkYq7fv z&x0Z17+Z0K0#V*|A?*PyP*9eT1Fw0Qhji;Qhr1dk6x-6GBr@@Hw-_X;Rw zKvA**mH*4n1I*~ev)b`X^u+KnVnb#A-Jbor_C_>kKk8mbBmU)M9bOp`(#nLcM@@J& zhrR+lE7sGSs4+wKVmS4z7SN;G!ALJZYRpt&zwxC3gLp1{Rmz0%3r%oT8PW1K|NmJd zw!S0B_>|9e;T)ke`?ii5$gWE-R!s(4gPxjaGEgf%6GJ$QdX!vAd7cwZ{W39$XTVLD zGcb>AM@RPP{=P#`k+Gc5ZInSDPxkD1hEy?6owFem{rLB_DfDjO- z?imRFnhwt$8R*Hg<El;T3^!imtdDuZEcmMH_M<4AlHBW)s5ABh5l;^jJB~YK|z*fTov1vZpIK~D2 z@F29l6NGWD!FaNb`|<)ku5h1zs?($U4DRXcs7Kw)f_kIRBlR*h88=h2mTcn{dITjc z%SCbl>*D|9lBvjnY9IHbr#YxS)kmbchjd(|mJaF7r0!fFc{)!ePd)7DnOr0b=iA|k z#U8cE`rA=^%Q`&>rI!R@)rKHM_Xwh&WDr8i1fx!{9&2N%VL6bVoktmWT5Lhy2I~LS zNkgSn>g4i_b7?wRxsR!6{*BCmj-GEmxoFhp6Tb4ge7sHlrWE!IE_sM*gNsngYwnf4-`q!1%}h_?Z%nu$O)~evsa(;q*m{3&N&? zXzXrJW+qUNDE{64v>r=#MPuI&3qCSFJRF;bYmPj>F@A)R_Z%>Y*MoXifs@HJR_2)~ zD;Kj`@cleg%CO$v^5~+g%pUD3wOrfDlex_#rOJ<&Dz8iqAP?~4TA8t8lb)PzoJWKYzo{J`AjH;7kFZf`h zcD6|#zdt1Bf)C5*f#lYIsqwmsCr)~K!ZuWe^)bxPi&RKl$QeK8%SWs_>{3La-BKN# z&PSjIbIcmC^k3R&!gO*NF+z`l0VW*VmX3!nGq5@&3r!vWSGTqDvrN>O%zpVIvJP1a z&DZ5*z+w~{<#B~(iN5;wQD36}S|`%^d{<*mNzM*T=CvZ*+4Wrn&LuKN z8Ob?N+bY(=8d_5`!g*b;jHI`!qZw;hhX`Yxp_(oOYinlVd{8E4pJr`!BRv_I>n|lM zcs)d+srQgIN%A{2`FYK{tkA^#h?fn2ndK$@odaB1cj{-7Z7GRTo}bf%PF{$7L@$nV zN(`*d&+n8P=SM`KEAN?ct~$K!tiyxbI^6!EgRG^N=RIl@?=s^XuhEMl6Q;2a{W6s? zWpySJ7Spej*J;MX420ig?XnN~3-UvkV_B=eq0n#uN;9e(=h3PEHF}jS1(c*qI3jG4UWK{YC0?`)}m<(9j=k#Q8-Z( zEr$LVHyKYuOjxv%*M?l9l6B3!W7rEAnT4+N=wo_-KD2E!(PR+yDpSEvc2hB4DJ(KMbJWhd}9s&4s zG7!I?2cpb2`URg3KtJw>*Lu;XV6+~CzcOcLPW)&vHL|WnBlH$$i`>)DQcF!%p2dv~ zEJ$s~v-1be_-xBX`WnWriaFSMJQowWU#}nJErXND>6K|F8Ld3U@YYSr7b@jzZ3QA8 zaKC9oEvZHdyj`up_k{{fOb9~K(Lf}I1mj0|5bl=>LJ8(W;CrbxgnIGJF}ky#7{DAN zgp75;zZN`Wu3Y;_8g?<4p0gwkd$;mTzdV;bTP_Bl$c1`TE-IeNWxbsGf0Nv0QC3Tt zGu2zJzVnjsDQX$VTF-_mbJLBs5ZsOAimJaZV-Y=PIy2qF5d?jUwN}@AqiDvynIF{=8y>9$kNPmZCb@JdZSJ|1jTK z#<~S-4C@Y1AG&-lM%nW-x|f4~x0uK8$;I?JRs^qgm;FKX;r_yT-bf#rUFayka@?iw zYCDYGQY@=FD==xI0$U1-rP2X<5_kt9oadg2egU{$CIF3M0uVYd5NS8`_{5kR{5TpV z8RyH)(LM%Zv4qDJHqq(=4u&%u^bqg+>ZO- z=k!dtG|0kzYaX-O6AveO!CCEvnXh#i z`i=AY+yl2}>X2}renlUtiFk(f=hj2@oSO^(H%^f z$*((=COc@&MBeC3tc_s3drB4@xnGCzx(sKGXv@7hoN>!#6WKlT19P(yWmA8X+#YU{ zC$o%Fb)`|pdz)oNq!+R-t1!ET8lU!iQj(odEa!1NW?xXwHl|A9b7|yq$io^LI(fs8?u$hIrFujc~2+4pHQ;zQ3}mo4~6FH zNrh%+u|iX72JfZ+L)u>kwbj30yl|+yJCq8ZQ0i1^uSMO9*WKL}33WFJ)JyRsK;4@V z>aIxL4XF!G&boj9dFITVx6eJp(DsH9_TFDx*XLTRI6=B~(#qVnd~S;AlN}!?3+Yqc zkk{rr&&Zo7Y8V=+kC)cZb3CNnm ztfxlolZ)p%_MPXntIV3-!wmK28Mt>j9cK#Z#owB>>P8ms-*z(-k#)NbTvzX{`oB8b zfAz2*ldYw!eSx^$_QK=(q43#2AHc&|NDH%*=_`uFw8aZg&xJ6LE*UXC%!41)SR%}Y z@}1|NHJ?M+fAgOV7|#!_W0hWU)Y4E686(9r-ynYx<@Eh-(e=uHu{v!XeO8FfA_4T51!W4py7Mw z$x?6Hw63W%|B)|svb->5s0RC@sB7QI#FlF|Vt24mZjrycL=Esy3V+`pnW$5dT5g|w zdG^f{J^4B@dy^4cn2EPjnn>Tbxq>QQ7%`E0c@^s2mB}Z5agx^E3+2@_PaN1Eig(ny zC;ucbW^O2NDin%oxHmf2?$-3ejB)JG?m>UdM&!%RS;{cx ziC1IK`N7*Ev?i{sRy%W`9Ay6 z5A=5?=5(@>hqM04hBPmDM22FSn!a*gS?Dy;j9sfjkEAl*+|SA zOGHh5`1F_%JlJf+=Wkgk8`(_Gr4&jCE5OsOLQ#ode|29bzUDQN_1}u+@JI4@jmSj~ zHsYHi3stPF<;G0rBinmp(v1*w+e!|rZ#F*UHY_pX9 zJQEi1`E+|7f~@XFxOL=NuCJr4=v^pV26*Awp%7fiscLEhjG-f*F9j*{p?JX z8q-WZO)Zkx(cb8JF$7gy$TbQte&ri1j_HyyzKlw?&LMK-Z^_OHUYfn!J+h%gg=b!BI^hWVFj-&0oZhNxe z6k;t)J@dt8wFge{`uDlPyyLc6I8&#-T#YOgi}7AqoX;AXDH&fcWuo&uTiM*IM7q@X zAd4D`AwQX8bR-iuw$ziPN`+E^{+lnT=l_|)`6TlTyq{Xim8J!v?n)ohlbn}=jW}^B z3-{02$^N-TGH9|FTn2KVsWBq1SvJyEHI(RH$C4%u;wK_IZ857zObnnUKU7~ zyF*dfB^3XVjHB;4AC4nGNZ-|U6TI;H6#X1e8?j51g^x~FQmK5Aq}>~efQO-2yn^{? z@tNpa!&<&(=Zp5IC*Cy;MZZM)i44wy{%})yKe9-kTa(Y78-gKL^a1BNYqz8=S&l3e_eEEum?N|(3!@{!Mf^y3hO^rL_7I`WUx8_DJ4%)3A34d=Zfm{p4R zCF2VmM>Umyh61Tef6RugkJL#eZ_d{#Z)YpGP$1(po|w-0b542AGYzwGyEJnvFWJMT z7Ww}X>IN>1neNcQ-Bx5qrP z2WD!uzh^O{uoM0D=+D)ZK3sEM1F+j)3lq<^W1{FwNI!upsSbGQ9Do5ST2u_7w-C&D zIwnfyULcp0pvJ`{EoxJf9nSsc)VEq$PiA85mLSw1FW_97`OCg$bkW4gmn)9we>e~a z<8^pWZMQ*nGZxc}YVaRBD1HXwpzwwdq9WBa=%Vu*x0<(f%mIz2MaW z^t;rRVBY5_@w!Fcsu6Rj7n2L)UN9ru47(*!%z$&i+Gzn8Q-eBHuT=QumSAAF2=Sfj zh(?9oE(rkePM!gC^$zJBzu1>}67&8i)`}}edpOc;e@F~U2&IZiT zX>=WpV$1t&aoRIgpoZ zq=jK*8hVzYSGiZTY}YuU!cFGhOC0ixa>7%$aS|q)foFFgxgFdP&=#Lr7>*=e@svLhT&enKEFFJpbF3-!poCGg!8CF`0w zA(B7$Y%F~<;~(Q@SI!TOnGZhK9#<0l@u3zuq(}6D{ab?i2~je%jsp%}3_!Yt4$V2f zrc@?py+2aU7ujQfy#ORs)X~SIKJ$3ytlQpu?QLHO%Fyl$3IC)jc2_<2y_j!?>GCxMA zBIY|kp%36Td(;~qfG30L`ElSeHoB2lW$*s5ro6wqR-)2vEe`Za#XP>x!M3sTDV}-I z>jUvuLvB5T-W-|arhVvxx!)1jIB(3l7?1Y#*vEI%jD7p!Br?tcLmLF3lQABhAE&~q zp&9*J#>!`M%@sJl4*ZD6{o1LxTa!89wId{gHO}(k0dPGXkM&@FnKk?ElreJUnj?Om z48%6G789p)o}|y?|GzwAwGjbs3b*@)jnC#Awv1Y5c+q)|vChj7!-^vv3{?6Jwwad= z6I--2?)+S2nB-XA7_y_cL0gd5Rb9q#@%zp)#{7-JZaxca+$wh4aBRfak_V(2kB z(eNp8k=u&B0}UOY-ZY$Oa;ED!?M;I&<*&i#(W8sYcI`5ZHB>Z=I;%FiYnB^!^&VxY zwm8O6p-!%0wI)H99f*}%(e!DYrWY!aGPRdh2J}8E^C#)$^1)cS!yJjq_RJ>;N|3fA z5@g9bt<3wVlZEWj?7+U!XmXBE=%-_uA1!;X$4i$LakAs6PUgOjm90DD#mQYO8%D-S zu_f2YNWIwT;-waO=Ie{;tr`(cEiH~2)LO}9FMj7oP6)22LWiF0dGAJl9M-5W(O+~- zIr=B=Qej{cy%TOb!8<^O+e1|7yiJ8g0qiSmtwLyJB^rjPQ0JhM8LcXueyZd-Ly4tz zRk%@}ee>Ow7<@;GU$4lAuXVuj0ZKfk*UxB$5`QW<;pJCHT%;ZyTh$p8S~@eUfL@Rd zsZVWHz{d4@)*xy_Yw@*Q+!mqcUqekEZHCEdO z;o6}(hOAsxdD|jdr!v7)OS@n;m_A z0@OHFBN$H}1fg<${`oaMd46#0rD>_%QWtll=2Dh(D*H!E-{l%Sn7JVydIaa_u=yV6 zhGG18qr=NX+%I%XK)Ksw6`RsmB9k?umpV+YrRUngTG18qx}Eg6)t|NNdh|^Ft;dZ2 z_6#Ac(+r~i2G(qj^0og^x8R=YsDWOOoZ~l`bod#Yh8}OoFS57T$hxszEAoXw%!?jK z{=GJt_IUPPIMbu2AQiQ<>C4E!U+P57tPJ}Nxc9g^fc+P}(&2KB`GN=O!)QTH@l+Zn z?@Na(HNMZk=+~T|hH%bj{>RBf?oLNR$22%@Ps6@F{26D{Q2z`4d?xYl+*5q&<|1Q; zImw-Uj#59Og^cQGBYnRpW&SCZJdJ57PiCm3-i4;ps>2D;*H&geX(B6^yGVS7BN+~Rd0E+B&W75{+t$q_ z^`nCvT1>yVsm<7PWg`Q=spQ?wrgD6h1vc%c4#FB@|8dkGEG$sXKxQ$RY~n%IJZ~uQ z^C|NNjwoQ=-GUyQ7FhVYNNkv!w}o{8kNxaX^(YaS&K7{J1zzndp-;3~9x0e3#T;o{ za+0gx7D)9Z_Byh!Kh0l(o8uM8WY652?j;gGwopEVx>HWE}VVVt^I<_V1F7BokTL%Ln6o`5^eMH;xAQVBJj;*$2I#e(wXvfu5*cLLI6f zImVv!h`h@lQoRQ5_sBqv<>#)pKJ8q&(|R3eKIQ7GNEE9&oP@#2DwPGNMuk*6-a-_;Dl|Wq8iDA!k*0nhAzM%(`Gb>Af}C$I3YvUpgDx`!nCG zd^RfWqUKH==Pg;o&14WiI5I1Mf7cqbu)ALt*6hi~iqotUtY+^pb@}2j=7YV;!q5?{ z@qEfctqEE1YncuEPuW-yNp^tWHzR`ifc*TkE$hD@`&AU!^NRjR z^pJY`T!Fa`3T$yv;LG}AaqOjlV|fca8AuM88POg7G3VwKGo|fIp#$^BF1%x%jjZDX z*52-aEtJ{UO2n#F5j~2FB=V~QK3~W=9w?M+Mzcf(vR87u0y72|%e^*c*~GCq{VDSx zw(#7)!w(bZGry7Jz_^WmjN}-t5;@lT_#q{ZxmZ_Nm-_01Ij(;2x#EM4<9%_ng)dwh zaa^Q%BmJ2VZjd#&OYLzEUt@lhH>#!jpfS-;UQLd(jk7sM$FkPO8lY`;4Rv;A!@INJmpbi6j<3FbOz4@Dj4Xb3^)=z` zH4}z4rWUr4KBfHgF>=GFAJW%@ykqWn6V}F`0@&(P)Eh!e7J3j@6AjZZz-G;F*IV#v{#;F}1Ku zg4+v2NWA?08Yi6x zCCDe2M0wz%msOfrS;=$amKw3Ly&=!F&*G%lGoC3Noara4LR2jkHXLH^WMwDncS`26 zllur%K~6Z4Z%`t=q6)evDqMF~!Y^C}Tb_&4sxjMPoio(s`Mq!1FJ^9mCKH_SIN1SD z8!;m-!x2wsC~`xibnotM!s+1$ga6%1}XD~u+)wtyqgb~w%>46Z07l~@rZmUM0 zA3?A#t%mv`{rea2%so|&Yk|QS$$ekWRlar*eZLjdV5lPvWERBEjX^l_fxV2|f?>fw zn=S>QOa-!zyL1?FMEAce)Wx^ik12X&zGoeb`@nk#$sWGdWBUX4GrH^XfV^W*p5^*) zB9GW5f#ZP;<2*e!rTt%SbVdF>Fi8*3JIs`(hB4TYxg)-M3~xs!B%l2>7j!W3wTc?* z@tu3lX&u;8W5wEE1wA_W=*Uaa4{}91dag~wo!x1ubcNX!_fp~1hTdiVX-IWv4a|`_ zd-dt((KHR~zS7UTCD}xN_AO6;kABqRCZyvj_kp+g=YiMwedHQlgVRxY75iKUr{VBy zdfKc?!>$GSAI&(RoaFo-VRZ^>llh}s3NL;j|R9+WEoR!57nO(Gz!97@n7B#`IPCCVi%-b?-1-%i~;0{;VLenrK1T=NH$*9&hYIhU0(x{|Y8P&&vKt&`}s zI?17<+($BZrw)5<{{AeIo=43xYzx=iA|Jfuy0t9A2S=CCOQbQqy*v1z#7o0GkTCib zg|YWK9F@0)A<>3^PDw$RE-BdXivC}d$TnUv;oD#CfqG`66Me0cs%5h#POgy*#+VCP zP&QY|f>>J#AKX;l%;z3{p|c#=Uu34NmF&p!?54J}Q z;~tTF&e`n4A!~WZA{;Z{gyC0w7)}mg26j_=cjvJ0CDnvAb5n4%Y6@J7Q_ykqCHggS zzvsu^5YF-Oo@5!h-?D9zgYDcuZMf$s-5gcY--YLeCM{*>nD#PlxKh4}0`cR$CUMW%&5PG+F?(5p==VDy8*}f_$Ab({zVynS1bLIXAldJa8+mS&*z z37$WPr(@bnh5O}^%ta#el~dlr{pl5j`}-g4d;XLlVG5lLy-z>k`bo0vG_xdp^inCs z8Na7FVbBux&X?u-aguChP0szd$S-yZ#;w_$yZNEpz;pf$@|D%~IK_ItOREGZ4LmQe zV%En$9rj;kKk$Qe*xXJ>JDyQp9`QU%?s|0>dg&D@+|S)7XK-ENo=KiC!Gb1_e4)w@N^#NeNI)Pk^JHo@*8R6RFECtdN0fDV!g@)A3?`IzCTKgAX<09b`V! ztQ78d3i-a4lP}0oxDVXJEX<#=GOtp+TnT00z|16Ba+jXTGgatc%(XRLg?g!E{$rIW z|5b&O}>?iDD;ui5;P5?@^)@ zly^oYTNTbUR$}60zNcGUleJ15pAd|D^VHNu_}six z&prW`>3ZzGmWS9B7|`{V}|E4awHOA~!gJ_pG79J$#YEJ&F0(ZONoQ?R7-r zwv<%A9t?n zbD7`SPmRHkwYWw7q`F!MH?GwS1NHQ4*CTWquZveYwml>hl19(AxBv0~>A0;{xI3I9 z-^u%Rl8lqJo*Mrc@{A{2$dQ+=C3L@1dN40IrJ{=*>Zg>?RV^^KKRs(3F`Ks(dnQ|( zBj>{*uYAy%K7Yf%__Cfej6JepD0MUp z;CaG5P=n-T4c2#HegoI9DO<@elG$_pn1UA@O{imU;=GiDqvP3^SLG|7a4xzslRbSr zD{p+*TsAO&F4l|~8CeCB+oI1#x zSQ9FQv;T2P3aSUD;P}22%;#GF`*t=ypUFlB*9|o})YCO{(2#5X{cKdt3D`$|HqDWy?+m2|z?UQS#wO9e8XEf$u@Al|EW?<^4h+5&}B zyz#a-`zMgaXAMk%j6)QJ#E%pFD!X>IqjDuan+Ng|M>(t7=A>i|8hp% z&CV#P;tZSPO1$Gapq?Ey=Nt54UBmwNd^K8d9_kyU#sdpAI9qIcwNsp$} z*;Bq>k8S1Xr_hYvu-xxXo0J9z?pJfmrs32)j`jWIse95Fk$;{#m}}WH)+6$hWY7b> zod2Ykt_^hJK1MIQSL@~H5i)PQclK1XLQ&J^w3aDfiJMa6L11PSb-hHv^}qaDMK}{r5Ne*S=S{-`6SJ zM{!>4M<3rJ^4=#D3U~Kci86xOUy-TwD^SOa#rg#KOaJ}-tTFc9!!;saiRG3~X#bJt zw5Rm7@1e%>ne-6psK(w<&WmBxvX#NGE|q}6TrG{pp_0ujM~-n1*RdH-S=S#(zOtN!d&>(6BJ7`ArPRqddNUeA^wMTT zoXp9l-k;zEFO@U$HO^djTu`r$3xbCS;rkag5U0kc5o#!JlGVG<9*XgLyd$gEyx_b=RUw4TbEXAcYa zs;85rRdcOWs}nEt=}~>IjZUm9>t%Y0GdTsGMd{DDyNn94AC*M7ozdl#8s2<{;u(SwdZdB-waUCr7*JWJWTxvbgV{~Tg+SlzNhU~gK_i^Q-B6~1p$C=&&BE#=ebd|6%36W7jjKWZ={g&f@aL-i#4eWC1SpVEaU)P%`5jlG+R z4VP+)wj#Ne8XlNAf_&c;BeTpiac@my$sbTC*-Jd((J2&1uNv_xIunOnEk!vdR}SA| z&T=%lAy(y|xM!iJG?KgYgKO8vgE|+pgT5uhZasO)j3%=C89Amue4Q5|ykABPe9C!# zNdt*^kt?mAc;N20K}~x8C@dCH=VPRSPycYov3r>k-y{pU7VeXY0WLA0(}pSA3Xk-A(KMBZ1lTK zoV08t8C&yYGT5_ypZwz!a&4W+CziI6iTXkr?&gVU)E8SGVt(;K`dwNz5l2P7Os~b9 zo6gMV-J6WM{?ys()fZFc5*g9c3jsqk+}|@__)jJtr#6j18rrhp-`T8 z_aK)=|Il&CxIUSDZWk-DD9M+RuHG;n2}Mv|GTy~x!mfWqu~rnx)5-LyzC_=^AaarE znONm$Ew0S@U2&GV&*~7YxNJm)Qkh5|*+ed8=gN`*4{V(miu)->G~spla;lN^|6rE7 z-8|9#dFup@iUha{uL z&P@EXuP;3+;Vfi)ImCR}S+ip{KC z2|LC8nsX@1@_E}eB$GUHBgy`oFZ=G%W5bu+Ss-~>Kl=LR@_xN2k#09VaBxp3vgjQV z_LVvHVa+9^VS(hY@PJ3bE<|mhk45cl3?T2h;X<*b9cJElNeJS}jdnSdiTH3U89b*% zoU3{uO&?0n1S8t!0zouFRre;j_7(^!}nB>kRha z2WKME&`dmn@}(F3D{V745Bx}mMQQFsG8@XG^2HLN^+dK;D00YO2OZ9WYr4IxI-V=` z!#uHiJh^WVa+ejUi%ei%a~TCTPT@G^yyR9V8BLe-JU*$hI1SGuvqWAvJ_L`xFhBZ4 z7XE3P$+yP^^2M9^-8|nw#!pX^jnL(=ehh)70Y=WMjIvz7~DmP4T) z^y&>o2PgU%_F%p_`O~^S`4YIo8(*n2S!t6oE}uTCYAbmeSSX8Fv*`7S`RrSa$mH`p z?s+{)(fyN!-}!u&p&#hXWGME0!Ag3{p9wCMti|+43841y!-&edObqa{lWlwRBzpsW zZ(Yb~-b}{N1H6y@>dP;3h?~g6hE3OC0JZ?vx61r4ppJw`X^2_qs6l*3CMFm|3)kE*-nR{i^&<8OYrk-luXk&;K7Oj zY_Qa#l0z!0EH}(l;9|M`6%h#WH%8Vdu z`YMtuOy2L0aii(+q)KJp0&}A6<7Ij)`tkJ)!uk>|-px$K{4r)YHjNUWUG}(KKy5!< zi?Qv~U@Xf_ijOg}`LPqGl8gLUiTkN_WFqJn`EFpW)STb|=g~p1tE)r$B63eZ_+0&n zl7TC^udWb?!VE3S@cuqIT!J1KBjxTh2ka}MALVd*QTabcIRAYMpNA|D2i$rbh)7!< z&Ke)1RSkNrCr62nyvyb2K>Qq}#gEy%UwZmT?ur%rN%V6J2*iOR9sH`$H{b*_PgX}u z*G`V`?a98V8(MVxLl3Gi#mG8HUTn4sZM*|aql;BZrtfF9v1)zk>rP_wa5g^3!>h>Owk`?>@2pRdFfe;qVC=$$a!jH2>!QYFy=7JUEtb+mZH zdEkl*`M8k7Vi#)JH>!{2u+^Rkm1pzFL6dpJK7zb1dj zUZ&7Su@X_ykzP#xs1mBhyc%ir<|{!A$DK`m2V7MJB4kTEbEF@`VF35%^`j+h1G!f| z52d#-U+dpvga**>uTzwiucgGM#Q`vr1zNTu74P&VaC{XbQ${KO$7P!u@V@isMn5P) zogL8o-_Cu?RI zhsgaMO+`{Ka(v6_2fES$Hx7^+C4c>VdMd7R{&~Q8?;<(hDdz$Z#P{>mgY!=p&Y$t| zGN!Zx5~$mLir_pf zBar)S+x&i}*A7;-;G&a`vDLe~8{alCAP`54WroAGmLgezw)tqVeRDfyTNGER6>(?A)+) zzH#BpOoP?>{e~y+UKv_#3pdQ@P~CX?RiR=0y_s%%FPt^3?z7v_u=ILElrq(@P+8YF z?ZQh#$4(F3%4!E0X1||kaCukXP+`8mnQY zv429{e?g-Bnwmi7F<#!LM9b);SSccZx@1v;G;fk1DZjNMvtlG=Mx0z$#7a`*M0rCl zIVgwU&ph~=PKi>jX@b16O%U~)7%6zhKGT%{(qnp_4zsJU*RwKvb=iO6 z(~G&)S~87%{hf=c`(M|iALnZ;TlTBY)-&&oo;>^+n_qH`c&o$pEqV;N&Uv*v{T33q z2JfW?|D8TKJ((+?%g@{=gvX`9ZE_k~PG>D+Ed3KVrD0KddN59=H$x_QMru~0BIu1U zJPmKigNMwZSL1SKdf3y$$A*2LbE)TVN=MzCH0DM9U%#h)Rr)mArsE%9|4K16LH_$6 zMLG_TCP%rEYi33Z=~B~48t%50$e&8-v)Wz;oN$maOPk2Ee$>|=+RMDx?D^8#O2S%8 z@xIzfuI+6uWo;cr$IR)juC~(6h2HB`o#fs@N4Zq2lBoU;GJ0q;i96F&A`dtV@>@$8 z>eG8WIg2lO$dPVNvgehvj7d<5-pW=At~Qgtds~p(c9e}gGcI1nyq;kS3<)wz9o81t z@_fIoQGqmBqQJKS3hbaq-11!|5uiMB*`jyDIOtX}pW0s&23vyD-!e#Ar<2>rUBQ4O7{c&ZU7RdP*W|mX7s?W4aHlH?v+#pB}|u)=m2Q!CcV? z2U#mr<$%LGp zCe(~FVb_Kf+*nFJt2S%o7pb3rW;e?RX70A3S3o8DC@eAIc@}%y_R$yePBPk`Nyfxg zWFWvy>r%;3dt{^Wa@K3C$r(0d?WO@4#Ch3xUybZyy=)A9nF*gYS@_0U@}Nfah)d4G zQtK?NTa%4jN2tS*2bhw^oRf<@+r?$U!bDHGB6>TnV>Uw!`yZcVBj;2$PTbAHwSTNL z3}@|y`bb?zY9z18QLZFkFpK@A#%zQcvv6s#i`dt1Ek*2WY&P6l23fm`S0872vByRt z;3Vb#Im)AZ&eH9wjcCpG66bC$x9hX#?X{hBo~DwFL@Q~$(?PC(v69h~9OUqUrji%S z9$|jI;AJCKzS@d&I|m7@$Sn8)PU7cjBQsY!%CZb+nYpWlOcq;dJJ6BY@2zFzNC!zx zRv@_#^Eemqxvy%LGh`X&tT&7E3>oh ziFCSemZFO6>n=m@5VFIjv+Uiar(=ZxdYm>e%c{c)xb?O`Qd^E)`kz+p%*=`udOL2j zK-i9A2~m`YKiT5QJ4LeM6mzVt=nHkq8^f%8Fw4~!`#zErZsdn3GQAZez1W{k7V#&2 zO8+sp!=D)uXS{G_o;RX4F*7vQ8+qk@v6k5&J2`Iht-N3{+!w~TJ}7uke~j;Bj|ckx zFIRK}d5A~Z^g8Y3iytR^(6WXvChCUavz9;Wi#Mv!AM3#sdPG|D`S)htM}7z@kX0BO zsv*;_LA%l#to}`J#qF&5Xqa0vUxQk#A!c(-)h2V2u#sB9P3A2WG0)v93@QA(iFzK~ z`SkMKxd{h8 zA!Dx7*RcsXWpc~CZZrS=F?~rFFmrkfGlkO0BfjNxzbFf;<5}=nn?)}I=CzTrS-}4{ z!7m%n&Ez+xQ5Pk*v7>1=mUST8vN01a$}y8=5c@T^F+@?hX0?hJ+xvrW=S>z9I_EzgMF_NdoH>KKQQEazPh;b*J!u&2a62- z@~65P!@Ugk^)Cz+R{Xq})ndLOD(8#A9R9)3;$X3%chx0^)qYit+dZlqFYk0PJgeBi z*x^APV~ti#jJk504Rt?FbF01bm7(*QRfecKC)`dQdvh`WO9f-VHEq|pj8|P;u9q@y zG$tBeUYvDdfw!O0GcVg<@Y8ka+1Ak*zbIZ>M$@ZgrCzk^IJxstCl~W{(zhg5u6~FY zTeo=md_Pf2*P>oBE?SdK`VkbP}>Q zUd*nsGWBqRe2&zK<*zsisH~OgmU@oO1gXHE`Q~YytS^-)EvD-v%!e$>GQCv0?S!&% zDzvZfgcUB_1Flj+^TP@AdpKeLK%Vn!IHS`p_AUKX!Pngp)BZSO;ZG+Vw@~6f`(k#R z=&N{?eS_p1Z8qOB`kI;p*X3+9R)qR+9;Xp&J4*9N^GSMN>6ex zA!H#RQeWD(hCNW%RG7?ur%m?*fU)dJc^Zh#P1X3jMvWiq$R9?NXB-s>yW}90@Lb<` zK@fKP1mPijrvm7wcz=HoPB#z6kQIRl@K)ocAA4l|>E*beIn!xsEPTQ}AZtl}w}arl zf&0)(^nsi}-$w2OYw`P=omQi9I{$ot*#u6(%*j@x?jL3XG}ggap~Jw%%uKth!=GJx zROzULu{1ptgV?Wfn_gaddYt6GuM+ohvE>rrKatr9(-Uy=IXzppvECX=*3n)Ei>f-r zvj+P651E|>^t$rau~$})rmKlSzEcz7^^chMC;+@q8Iv#2(OI-0Sgc{zTE&`yTsV0@D$5mA%eY z((!F~8Wf|_@nb?dOh1{!>7R!7Bj|&sWR_~Jboz#+;Ylm9D4}V%>(30@dg=5EOvi({ zjh6&AA}fu@N1|KcH9YrihB}W%`oW3YH%j>zpP;TYiuR2 zN6p;*LJFe(k^O2!|D;Rg4ZO0ELjEIjRSwRK%ptRujls^$yWi>{C!?L^`JDE$RI3u# zAUo;W(LpL*x4@KO3v`##_;K1S^~lGa%~D{%K5smpGz`TNzKD1^98vxJ;Jt4c0=I`D zU|<-ImJ7$`N?};ga5vuf48yuMmr#xK;;&}RS=^a|XJ!*FOiRHiYWMqv9!{Lc>N)4& z=BjKIS~3fg-pb)FEu>jRl{9x&iR`nHJZn3#9;d)zUklEq7WgvO0^b%{;PoyA#!vHu ze+@rm@)}*A;0yH_W_J4d!l_g^a{n@KnrlTG*ADL*^!Du)hO_hN`=w36&}SwL;oSZC zp9%Zla&N`?HIY8l)i@{5xX4^(UYk_1Gp&y(#X`kwaA_rF|F)4gpY3JvB<{nPmcqUz z7U)M`soL8V2s>U1o1_#ra4o#&<%eUVe9_0&7c06C$Ekv0=w}^<6I|=AZwW<%8Qc$k z=YF$WINoeZW-lvw!7I$`Oy-)B$^D)?*O(F67!kug()VnPw_r{tuh0A+S-9QPNpM*u z?t|OQ+}`bE-evluopzA3mAO|>D}|4z6*zi}jEcVn+P5f$JA?hOq^B>+9`wUqCm)RE z^(vlCzevk4m@kFFMXkZ#KI{WHz~`x37GD21*d`$Jxz@%U3uQkC3|5RjGljk@TzM9WT+l_ zdlInHI{|Sv^loaYNA(&R2pW@)vpfryzMX+%7XT zd9d%zD;6HKG$R)E62)m~mJdKLuERJhL^qLm?fogA#4 zBr|Iz%Fs4?>Cr7o%QtD` z_0NIVMY%VKp55d=gM)FmZ!mol^tdr50hxDnSf8Xv3kP~MX7l}Vy|K&XeM(BlhkhB@ zc_$tE3uzd!i5^nyGk;pm!abfG$TlZ>OZhQxb$Ohuphxu8GDifhnfKbCxg|a5dGXc} zvCd>+-BqZ>eZ-<5B?jg(+k-q)qvd3qCQ%cbNrvYdwVnVqnm*R!3ZI_?)M7sEO<=vB zpUWqp_v3Vwznz9hYtk`@Y)abT40=^iQ(2*KFVj)sZoaB;k6o{D|FlivK6{wL{p(#j zxsujZ-u8DEOO;C2am=@#Ku@c-oNv07!lii%IEAx^vYP_GI0rT1oU?4PFRX8KPFDF~ zZ?P{tcs|&9m2(X_v}2KB*q+S(qzv-!l{oe}7lv=(xpjOB{@qN$LhixWk!{?Nor4bj za}de7aLI%m?CQnL`}Oo^yxU4NQEkL}gi1DDXeDib*hq`|c2eyIdoP)z>`Xo4)Xx$b zQjgwxBP>vZeu%B#`yr6$o9NA)dmd0ELJjf3x7Y$=35YIlV zG(N!`V=^+*=yC;gc-i&J{&tPxB zK=v^`au$F8mQvg|g;9q6g+7=})3sg3+#X5SMHX3f;##9s}yM(PhuE}_M*WcKdx++#=1 zvY6gw`Rv28&!+ziy>mO{U{P@vy3C~K@kRdZmP#3yZ6l2zI!f^`2YHlaBj(lY>C3TT zCb$CmwTnc(nEt*s6gcbVgHWRrWf>uFg)(AL6V-?*OS8V zaUOdXmR>^7N7ON{reFcjT#4QId2I?>x@O}5ed(+4I?bHI_mz>2{*h$iM>|Qx!dCKR zZd*zF=pw%~%yDhhMn2Uf`!HSs*TWXbyjdu2nqrxnTP)2EdLtmt8;g(m;C*XfBsBlRsLQp;7Tk+_gr?J6~DgwyYDwI2K0(O)k*fi)%eopVpVs~`b64jJsBNQdRn z4Cv}`FWWF3b-0ENrib0!LS{M}6z*L%D%_P_I9F%TUvG7ySY1z&{A-Ca*)u`X$0SPH z?gVMp*cma0S|IWwna1kQm`4`=`zU7|ObtdZd+5D}uwTAYFb?L>cZO@)+DFXpxv9s5 zBg`!JOu$o(4lO+rQ12Q2b9d3xwSCY_6kva@1zdg|k^3e?;E9 z4zJCN6-i>Tk7v0KiPG;;yiA_27njE>tW>u^`*!rLOyhcSPzB32&bW7ny#ZaxQ(h)B zIGgjdhG(2n!T2{n0VmY-tIXG<^;`OX>|>2^a00Y9GvMh*u5ubVJu9wZTj|5TJRSQ> zS-78>q;S7S*7Kr~^P!8v{U&<_-X7x`Iv_!2oJo|o)sM>7)=6@uRFdr0w7^jAH`=ie zt$R&pOg`<5X;YnX!G?@^C_V9~1Y!L2Ahi3c#?IcWaQQp6@Qw5X`9zI;z8?P`>dom?^;cl^xd5H98JjA`n{4ommRo2X#c4c4R-=h-D zT8M^BV`Q%+DGJd_k9lNYuQ;QLyEERg#&FlN1zZ<6qr#tHRH>lGi=}F$R$PV8Jo~8^ zsgdWZ$C_N8t?KEK@k57f7d^^dps$CLEG7Mp!wu=k_?U{e)Ydb$^Xx=+FoxH|F_r8= zw8H&5uTf+adlx#=S1C^`%O)ps-x??919bAxK`#-%oZvfLg+{HE%!i~mbX6t1YCGcj z3HD8_{XeEreMgP4$9R@aq7QR4+0M`OE%8af%&$5OAD4hrWKmOZvVPc(e$YIRb-tDc zk80`kGRQ!bkiqA=KA(FHyRE!m?By8E=lZ`|*nb~ZeJrI~26><7-nd{Ff+_3+3v8c> z=}jzUO!Yz;7~z3z74@p>Hs*Ad9w4%EE-|jm7;o{mZPqFnn7G*+k|M7iYrbc~dDfDvv#veQP2NzmEE#zgndn%9+?+?gwA(Zk-5o>m^OX?|YGz@1t0uDC?w_RV zJyGgW2nO8?D)!LND3&htSUBj)_em{&OaXb-v5h6QMxiug-t?Ctp;*PU__JG? z`2CxCvSa^9nf0FNbutv{b4Ik{>tq`(<#6`@L)uyYMU{tdf52Wl0L37b2C)wV^WSEZxC!&XA?6pPCsa#h9%bmejD*)b?Y zmGfB4-EL?jy~tx0lYbl^z-L>p|K+xQ$?@}?`HxD1enoE~@MdJL>8-vOtaJCkm z-RAV@Ju{P}Li+5;b>1PDTH?ffbCW#SG`5gnb%m@O;fqeTkvQOzifugaR=nQBc9zR( ze$FRci@~5j>a;D_Ws|ZZt=W0;(YMd(Lj$TAGTK zk$IeZ<8`#AMC!NohN20*t0!2?-AF!^xyCE67l~;dZ=B%qpZ#2q^DB7XueB06S1h;O zeDIHD1a=hYQC6EC$!E>PwN|kh{_@7BIgv=|!TyXB`yFkY${Ky4n0*|9O!AC_caUR^ zVz$*AE2;cY$UTz}verbxlN@eoQZCNFZ!Vn!nLoaQIq4h8L6e(KBd44iZYM<-d4Avc z;7J>vmqI-nT+c(}pcYbiw@6(69)b2FcwH}GoqJaqo>&`8%@qSCkGc_ILnqIqf~m1 zz~e^|aI++rx*!)XXW2-8e5tfg^+nAc5ilqBU7+H5zu#Pj4JnnYj_gs;dmEdrN7ORr zYj<&!4UVPqrjs9P42gglKhKww^HBR{3+YIHS=rqew%m`-8kmZjW}N$P$a39`MqOIudl*(0>${VjJMuhXyW+de1}r)YXe^Z5SHrK0a5e*IxfF+W{M)|9=? zsq}9)O@)fTZ{y`w@*<>A0>As>6VFSFEczl(=c4#@3u!Z;SZca4PwQqR0(|v&T$#%( zf)-?ROJyB7_sPp6u_9NG^e0QtE8IIKbRow+(=_n0uuxu?Q_8yRS|tP)>tACsRQ9Pv*lC4%a3uc2Yi?-lyI z=F<~rN-yE}5JaCO2ULarwZqI6J(MUn%Iu(66M_qaROqycxycokQ2EnGO|DQ@grX0* zr{1H|$x<3IJt$F%=ueE@77XKa@=CQcFk_q%u7Ss7<7r1sn;nb=?BV-Za$fFLC1*U2 zai+l@ny;bg#M$KT!m9w!S=*yEiK`Ox=C|C80&eiglhOJl@muRSyD$Vp97<4XNZM0cc@ZD+jP z{KElf-h|K-slpiYM~**?81ng;RM|p)?Rp4vy_2wF0{2rkWSb7zI%*?SebhG)RDGmk^N1X0t=8Ff7r&wW+& z#xvJ@hY^?dF^~JcJyOqwz;!7508i85TS;GJK#Z)+vZwzi4A$fvt=DFtdqE|}9pmS! zwF4}xv-h!Ag@h@Y*m0r~Pv$2`8FRYbSBGNV8x<@|>IOQZj;4zHu4qrn(^R)zMB zS;HGap0P)qTzKV(r1A8nJ|QnQAph@Q2|IfVO8uSU)ij`Mx zPB>p94FB9vXwZ?8vjjaF(ffFh95CLuWrB4{OI~y;bp&+m`;p2mJihRbh7x_HFta(eQelyn5n* z`wf_99gu{un9$d-P0YuKKx9 zY&B6KQOmse6rRVTcv;KqD5rA>^4yt=^N80)ZzGP^j+Zv;c;841Mb)m%gXxfo@82si zm7HvgP03% zOOBGSzrp*!$T4x!q`m`|MTB8%eSS_>&>KfSbPb&^KRP&}l>GP}UUyr!Wgs)qh}dUb zkFGgjB;BNm z%P%i_v%z!I?vJ`>W~Ta?lmFDG{Ozf0y8o%JaakR`*I$3@77cOGcRL%S8$a=E&lz7$ z^p8z0>7FhcsXuIALuc4M-g9XCs+Svf+n_tUYNKb9^Hw@z$1r_O(~h1dmpgfsulrL! zc6?*qf!qJ;F4qXZw6oLs%NOX)Ng>aedrT!Q7bS`LnB$UjH&M=9P>Cn`#-|$+<=jGz z^#4Lnsds`5nVuvIKXcZwaguDEA1^yEBuT8FS~g5%zncAmPl`mT@;83X(MmJ*3Wgc^!>|D_xk`BlkuK4xX2{s8%XwZb26wxkt z|J)f(In#ONRw#5)p;+3Dvy!Y&`)p;sYHKKJ^I6}9vk~Wik#}W(dd5U0x}0I%dVd&x zc#^q($+~(iGP_rlu=~gyB-TxC_f+CavoPdU56Ag6^!3c;-#M$qJ!d6$&*63cXE^h0 z!%*SQ&+ayQcnqwOC9x*X+SG1aCGtF#SjWB5yV@GG`=Eg(dnvVT=&s0MFWQRUoG0Y( zn`p3{z2@aV$s7-7_R}>D8n6a&H%N+$F*HeyPu1w-xvR!e{+)@Z==7PX z#{2eGF`96nn)EE*3+P(fcK2^YW#VEnSNvyhq4yd zK81PEoYyFt%X-G)EL`8mJ=xG~__fbOI&1Vhsxc#jeP^>Tnds1sb)hGjSjw7E%y>F? zqOxFb#x;ZWtK(joSkQy>x&O^BD>Lz%b(;G}nGLm{f4@8X)04<>U&zF8YwmTdvM}Lg z79Nbu1UhCizs+8(`?r+@ahBL{H<@kYCVQ$nN$+NMGP8=al$zPd1kODEeZgKnY-lCj zXWB_M9~W^Cw33^@?8JV!gPgnNESriPl)^hT!y}W+h zMgr-q@n&t>pR?_+EZJ-IvynBm-NfCtwQPLMezduR*mSIv+EdEJzqe5itmm9!8+sK} zDp>oklp|M+@<)H8Onaq3@C>8$t5Yt=nk%3@Mo<69GFjNUTt2K)V12hTnK-smt~r~a zPhE0X4(yXosg$oV%)`A_A^yKB<&Vt@9R5aMjyHXEEltR?Gpl-jr9^kDklqoMa^;Z% zveE?ct9wnVo<`j*JR&+12 z$Lr7f(U7rG_{LiG@HNc1UBo(86#a59BVn~M8q==RyV#kIxj<%5vlr4bggxr_l;&XF&w^^WT^8Ym3%LqtW1K)EYp~KnDY&M;UNql>tij zlxuAjmT!8riYW@+%FiJPc_1*?^>Z23Q&la34p% zPAOT)v{YmsGoafKIssx+(fvE?9_gu=-H*@BW@)%PleyDB^%y~}OXru0kF4iu>!hLJ zUjy!%{?}LMGvZz{h#}+*?Ab4F#Qw+@G6=VriNL!1fVK1+^vuWR^LfZC&d0tf1-Q$) z)4J~Y@Z@Wsr7=7A95bFe<-u!k9_CsXVAYF!W}4-pK$!>YbM(r^=Am5^_N4dZNX0B_rGvD1MqgtIT}aHJ+^-|s z!8%=mC9j*}3b{XxdG0&PW!7Z{{VPU!Raq{3(-rU`2Rwdqh0KkslwBW`MsFz$eVIWy~>^!b2Xc>-{hNJDSh8pNZUmU zY>72Wyd&MK%$s)2QQ%2u_7L~_BJ!gjEK->fwurgy2LjN`o}YVizjetOzVP;k(aayk zCH|=M!51s`^Sau@8sJNRbgCM_enbEokvYEgmp?A{VK#hi=CZw`i;MMvBW3=q53sM4 zO!sMje|+UL`svH`VD0zEb9ZKd75d`PUqJ{<wPPjo7 zdW_*U$$nApE4sgU-94#FXX>OVWb(C-0-~^z|KIXm6e6y2W;~Jp(@o@#hesnq8I7I% zJIiX)?{tIL*hkKnvbNSL+kmr5vcJyE_~iApwiB6+5xjOP=w2B^H`Q5wt(O7cs;A-X z83W2E8-THCm_Cy}l-107<8`JV!fUk=ugz2B78|D`_*p6@pG<` zk*fh-ymng@@%67$(QCAUGYssh{m4h%SNV7_K94Lj{UsmxxhInty_P;xW};b>&zRSo znP_eDq4~@l>YJ<|Ud=-lUW57vtflk+nN8&EI{!{A@;P_PY_}ltLB0hT8kC2P3-YjP zTRxgrqsQ?}9$t^+b#ycz)_Q&|f!E+Z{=9$qx~t5cc3-SxJc<7Lwk*#%+iPF8od3c@ zce=LjVZ=S1`?_%b%IZ2@%iT8mULN&58(iwCAJF`&?$E3+x>kOhbTw6tJ%)c;r}J=` z?%|WYMVJ3-y@&U}Q@Vf+or%Gm*sl=zNTFgdsrm(6;wsL=1 zSeHKT?P|^tsn~Cemn+U1u_#cBJ?jtqdyq#os^oXJO2*w#$s%wzW_q&h&EnrrPLgcX zBq`s-IZbt%jN|vUaz(qw&RG4>1u@(QHmO5r1=$IZcZqxF zjDxpb5WziSQ13A8cUPiLeeUzDnJYPo`?tDbuwY-)ezX$N+_x?76ppNY;bd{>C26L_ zm~r%4^-yB*3py4jDly1`E{>*3)E*Ry7sA<>+05o(eW1sm{643YSoWt9uGwLTJ;HqI zc62pb)5GW(0$(-vl?}t;)HNKRxyL-di_e66)wq+O#)NRrp^)8}^o@**AH65nG}ymc zO-C&KFzk)l|59VmKn?Qz>Cv*_Ow0fc6!q!t{+BbZ%jxarY@^3vdb)j?ZPr;0ud`}Y zyQ#+MwQ4kZ&Hn5;HS71x(L2l8nNU7wr7_$34(llFw^hmEeA!ZF4Ll`3xtzImAhCHcwekb0?dq&%*auX3Lq;#p03$PwwL;Mlh$9Tw`n;=Tx{qywNZl zPf{{a@R~D{37K%__f)gj>Qj^19Mzdy(3ZXw`z$Q+qTgz7CN5v+JdBR}OFOzDyU_pW zPcE`L_mk8AAJ5o+qrIe`bd>qmT&4YUH+j*qv&{WsD?XtLZ2VOwBk5%zFW7+h zvyp?-&>_lzSn_DAcJbOT&cm+^GS3xcpXp5Uos|#gGAH)Mm@#ecDE^z;OK+o{EcoCi zH_n-08Xa4+>d?7eZUV(}u0>=+{)rC2mvleoBKTnf_gD35=362D7s5>FQH+I|I+o0;OoBf7vQn6M5;hGs(mu3HCU$}M`X zS_NX*s6b439Ec&V(O7wlp1-NlSkRq(%7bY9nol2?!hp*8Y52U>z~_!M#H_f&%ohVD zk^^6y!h3I4KCX}pDR!rWT0`bw5FLn<++{{}XNllmd(=-CX?vZl$}Cefse$?2hky-_s1`9W_L~s!s!ixaOoJ0rQ^xV*wPsZI;F^;wy4ehpD&ry zyQ%ow$o<|s0|M5j0i|T%6Z0@?Q2}~~=VKy|OX+jYe9S4p$K9^d+p)8l)b1kJZRub;@@QfBqGEiwoETJYayPAM>v(^YL$Ot~sp=;IN3F8}9L{ z#TKBSlcU@yv6r=KcX6uWC@YxV`S5dVxmvYC?#?j5ja~}eBX`;$M!|kBIi5#>_~T9> z_xyo4d(|Jq?*&5DIRMTEI-89=R~mkvdG0K@ANZLPg(&h(>p34V>Jn#sxPGQd8oX+y zA!!$ToCi5qqsm8ouL9QF=^P%Gk2$^?*)=UuwiapRSB+%m25P1EC$)_F(+L)3yhpEf zhQnTGT%PI%Gh1i;T*`dl6U>~BQKH7PaGbFT$3ay%Iw$iPGlp|>e`>KImu%W&Ey9yE zaHbDvAMXnX)Y<5MGYb=W?RPm%PtjcZnp!hggu`8{3ghfD-HdIN5RcV(HYOY& zj+4)8#reQlTKW+=4|tFF$ZRr&ZhXEymdW`Kx@ccyqV!27T*!pnT+3PejpXylUu+nu z@Y-5TXAT=6BC zp1*}kbi1L%0@e#k28HALrZD_GMFym;77e4-7(GqP=W{JO{$!mylsS~E=x;hfSENlg zG6wT`+%p^7SqrP0tngBhPg&lV$Evo8S7Z9EUYn)JqRU#j@1>Q9M_LK{%J+6%E9$YX zTx00ZoX2yO#dYx}^Dw5l;8Z>G^UvrYd(D0U*Qkqt+U%57pxGGYuw~ zk!k0e;Lr2ZfK27EZCQBOp6uz$EEH~JF6C&2S4u4tuVcf>snF3__dlMeMB$Z7o=ACI zExjI`kP)vrXM0s8ZpmuSCOX5*%mr0LoR~f5g4-uuF=>k%o|uK>;{0$-a%4v4StaKd z!qJWAFl{dVW2|FL)M;_^Bx@$y=`NV9LFomqA4ADA4#~pprCFG_m34=!L#J@WriH_cOwpH5O8hZOgCnfl{G9Y(rUqH3Dq2KZYjKM2r5}I( zU_&O-xVAYqc!F`CnMc7|@aTQ?DYRF3WxS^2ig~Nw$>+wowUsKToMm@ECrOER7d83D zj>FvKBA@$jIV$jJt0@w*6j0_@h@RKG>1n({ z$N1mQQdr?ATO!+teP(+(_sUJGF1M4BT0Uo;Rv^Q)QqoTu#ksZ#-bV6%nB<2xy8{r| zkB)k-9ecBaSl=Swt%!#Ckv-UG8-+a|qmbhqjRM}IOAe$lyUc*)T(@R(O%1_C)$)kOh5+u~B@^V21MYX!u!1BaH8- zpPtX?e2#Hgn1-lzY4B;3hQoYr*SF%@If`pKp9um67I4m($EbDz+PJvM!L=Qv@x(6j zkTs=wTiZ$1;7(%Nw+aUH-YioT=roe7-t9_e1~7+%nb#wF_`~UtKSurZhxP~ExdG(y z1EcXt$iLr-Mzohz{p(pYh zpUoC?jla(|>=jwl+xeIrLJwkcJ}&aSSs&paIz0!a+R4J!t}-{*S$49{uwh7BF>g~T zZf_MBzok;@%~hanCEZ%q3K(Vv;kkI9X2|(k9-oYL{%FAC^Ym3TT6Notb9z40 z^4WA=y*(Jo&&~)xuBEnDkij)x_VK-4=5cz@{E9H{fqHXRVJhn*;8xpqAc$LSMF z94%4eyC0n^$?gMZC$xw*_1$jwrk$ zPIKM3tnf-F2S0-SQ;T<6*+CD0C7l9ScN~{hj%qo^bv4k9{9?KjI((#KzJ)WA;D%*^ zbka9gqTx68vb1#gb_iz(57>(v zQr#8Oo37eMZU}wpg316_ES~Lxk#0&<`Kg4C4E#$`;sBp#>J1_PIaq@c^|i1ati>fq zEo|m%aMel+`@&2ljLJg)nVesD&c>BFS?D;2nTllJ`*2;K#`|&!|8)DQ@cI%(ZtwL8 z88lxbSLP?l!G0R)`-|-0g5y%-kqb`tbisri$1xTkap`{yan}=gsZRR6gq6cV{ z5?x;^(JV;G+$Sy6ff_Wur^WOY^j2nQn6<3IR5GW3&d)}cR~E8(zOn~rY+nyDUt+F0E2{b>OkF-@*4qmvGLWWXZjfB8AOVVo_Tyo4%=KHu=gc>@`>paK?<| z>|+GD;7ngS8<&M+*bF85MJnMvMhVkGo-58#jOR0y=`uc-jpt{kj~0_ZY7n$TgD-tJ z+x3a_8)LKJ-ktMax3iF=eCCXvuPe5$b7j4WtSEfrqg zWIszL{6C&Cu9~@AaxY{ytv8O5qtQArM|esOes*XfHe1W3)oF5n(Gh6-UXPtS^YFN= znOwV7CTD+>6SRrIvxcnWtjWc<6;0$*onMknkKyTo5ePhHfUPkHCDG00!8-cptbDNd z-$?8lPkyj%F1}Z@kOpSuQue?bQ@%#RxK58y`#g-TXek?qmoPKN2PNdQ-rA;O$E95S z`r1U6{VbGyEq(D%Xe2s%vsSw!2c31zWM+1uG-~6G{X-*hmmE_@MlO~)Tg!S4IkK1$ zI7=RC#Y8<+fw`D`wUyKvQ!bB|(BG#cxAl(PqC4}QlbK`Nyi^V^_eRTL&IN1qc%DX{ zu{vMhsZ>5rU`}gsB&I3#_;xJ^mzLF+EL(D*;ePOOVf}7!Dn^q}Y&FtSCh7`hS_X4( zH%FpMZF(D(xft2fTHwq~8F~rl#{I{Q>M)mF&)rrn<>|p9NpI(k=G`LkXhbSTUe3c{ zG?zJD%O%&8HA}}xY$GSNx+i^bUt3Dbl|q@a(HoT`BB8Fwkm|RJ#d4V++763AyQ6v>eUgjd zzgx=eH9Wsdy|Ia&yRrN}BmJ0@a?x6Dk1v;-VLmt*$h?`QshE|X%k07yl6SaRcD?t; zOCFzBXUJjw%EjfXEhTAAk<32hjXL8a=*H9|;6xq<3~D9cElT8RZ~EE>N8qvtIWLbq zyfS&&AncEoA)#diKqI;mY@OzJ4mc(^8c_hHVpgAeW;jX=xKI(*0{|24>3`qnL#U)dvYfgIm_a*+xf zdiQ?NXJ=g|)pyamH;kVv2m0pB^Dt*)BQfn=D#ZhRV8>eR97QU=ea%Hd3v-EO4)wQT zKFnT^gkdr{L~@angUw`!N1@d5_QnYEuulK#5z(CWO#5bX-J(=}_wd8>LlJm-R*$;9 zb8#`cjl7F5lA&rJyj&FtH*-DA2haZ?{i{<-A;U8qrE-buN{@ z^cybO9f|D8%%@Js#ryH*(maG-&Y3=_9YL>OV?BaisHMlR zD|vW>7P4+(sSM(EG&GkSXbS7V?{cy3TT|IRxKO5(4_!DS3ZpDiv5eR0&~r`Y=HwE2 z$n!O)7JEe>_&(R=V!01{46S&4+W3<9Ag@;~6`K$6_`5WfSu@JyO$T4xoW(rrL%eT{ z%0n&YMlJNH5X)#^JXsNmFLYMu+U6kac2n8Wgx9G#=OPv`vx}Tsa%m2x=eLkX@#QjU zg)f509lNzjMb~dR&~3Dms7-~kmUVZj6NxjK^c(ic<;=aMTx(Dw?U_G*o%gZcr*)ib z%EjJ&w(|9Jsl4mui|ax^CV63xlYIY&t>w+zLQ$ywV5k*|tLK?FT|1AnEmktrtw=ia ze3kP0{o0Fu(k8iNugsCLdXeXa9)0dG z$2`tLTHY>~HjS9=^ltw#SC`_e{yyy(qb>x1)+m>*5ohuS(1t=z5T{r5u2OY=c5+X!@IAFlmB zyq{0DmznQNr0dTS=#mmaZzzxF=N#;FNh;X?la3E@Mywm3BuzisV`=SB{K!Z`mOK57 zft5HSMKLa~DWwHN8|k0(#pB~f|}azvl(Q1)cV&GpDYGjf0RvX4pUoAeu| zGuN1Vii+yYOPov3n$0n}V{~Bt1@kC$@+9?BLZo6i-=4K3$*w!3Olu zmBfmd2R(h?!jQ<^-e>gR)weJrea2C#zR3ZzqC&9PUxndO8Ax15-c6Gr2ZlLda8d{+ z1(K(mlY#ulm6%r$FHZ+MU_bdd%RMTz9+81x2aT*-9h2%$>@jyAzrHXDA20CtB{y1Q z{!uaK`|%tZjEoN|T-0Y^)&TN-n_^`KIhBs~!CY%p*!4Iao;+XWjS}Sz^Q_Oik*{1r z&XMO=ai$WDa*oImCnvI%Ay~zH*b^1$sL{-byg%Y)W1JnfwF||Uiz;Y%9CndQD%=|{ zpZeRuXXPryk`ufhK+on=BgR+6ib-92^vGHThviA+`7&YF$O!8yv9iO~5skWqGIx<2 zCC~eg%awRtB~A*bIAL3Fdi``NELfC|_2f@W>6N=M#Q|ME2V;Is*8i-Q;e+HCR!3y-Dm&D?8w{U+lMr5#fy!Fs_?+UTXqp4UOGDr}M}?eZ z=4c$+gGM`@v{>R0Z2qa-GAB2)cPxmb7$0;!t`{3zLw^ulL~f z-qR~V%zd1&^L8ja>XG-Hnt_csj3~YnE9<`5BP=VJsx1{}@%vX9Ys9I^(e7WtT z1dkQ}G|~51u~ENwqLW^^Q19XGS*|`%Za2S7z$W=I_<@ zshXmjxpkJ_cKTXftF;p@*KG1z*WM<}qxJT$p1(J}(G7O2uD@j3TwfIRz;ol*1YJSh zIFE$Mmv#Bq?(0hbYM@`zVVrKubyI!#(;d2HtlMm&C(++5Sz^v6N&H`lGFFo$)?Kx7 z*)3VxhpOc>8O4|hDhZmWmN@1BJtvo_Kg3MH1Ie<5z3UUKGdoAAq&HoSk3y5hvs<#X z{>Yr_iyCP^FiG|*RWgGfNNp4TGlLGseOhUGCP{9Qlbp&vwT0htab)kh;U6k#w%7%m zIYXH?mptJY-k&S@-%jiwPj;dI+67OO=}z42gl3&x5y#gmf}GHM19PJJ|7QDt-UtO@<+yxyEaGl-4y1_tKykrmM+%9LluIY^2UH|33yC7-1Ggb~|or8ZO zzd54G6GvPa?Tkgm{22?B$f_HTD?RA_)rK)6J`5(DGcDT5+0KPwxHm5ho5`}bjt@gd z3VFuiVc2z1i8t&!w+!OkC+kUf9))1x>o6>D8wRySIGM{(*q*0@qOTIq*tfniISl7* zm2~{jDazNY>(JxKe!*nVP~2^z#AwbKL<-k&SJtSi)2qY#eGu15)5c^NS)+f~hjWsJ ztShLQ0TG~vcNVk%x@&R!DLucA8mw%@e)e!JPVm0tmPl@~4{IXBSR*N-ua*6WE!_9S zepVqOh1~i%?g=c_>`|!E<1+VQV>LMSo&4hxW=^-!pw)U6mX))g(~UV>?CTWG%E09Z z%#cpYgzqb^#q3us>z09;l8O93GBIl_x%~54_?W>y^+P(P56~OonuSqIvM`o47~?+n zrmJSbHaipV$R=9d;~c_i)@NADQlH`BiK4oAo@99^4 zve3^16

k(3eUSN@wI2>xvLzU?kG7;9mTIr zYq?f#Ex#T*$w1bd7p!)W?5_4=H`i6}ZnTwjD+l@2+fIgsImyk%E|PGY891vPWom6_ ziLr2!PN{Cv>ye$TUt%qJlkH^iTs!${XD?BG-6hYbjZApdTIOh(L;FgB^FGX(Hdi3! z2KhymQ5=?4$k%A*PCr#((gkvk&FO*jP~Z^1*6gn%`Da_H zv`kQ-`X2$PwVRAofgf(A1R#L?;-S`o_-j4;3JF07@9l>X*ZomtJKZ)t>5Y5thq++y zW0^my@|myKOlIP;@44fLKfDjnXAnXUV^g~0d;`$pOaRR0_+#^YKj>opG3=)==UDyd zu?xV!$^bkgU)8DDANx2H*u&Ew7PkY)Q?UOY6U~_$a!`l)9CeqTx7(aMbSF#oo6g2r z(YW<75>hL2!P-p4abZwwi&3O=VQ`E%7#INXFj2=Z7VqscPHvQN>2z5ieI zF`6*ns(}HnEtsvhlQWWTWT{T3!oDND3?0*O{v~VUX3WdoXTXfF?9G$Yn&Lt?!fyi} z_cmbAs8kHRlZrpa8(3#%jqOY-`n0Cwrg|!R_f5sZe*77Espz;km3w|>cNB2mEP#EH z>S=Ji#q4V5Ja{gkcX2#31lZ$mGMn7h`8?PSW>yn>ImhSbWBm^Pvl+9kN|=Gm{zVsC zG5}#kvQrkT=|!kX*Bqbs{j&0~lz->OOuoK6 z4+;EU_2=i|5r3ZQaX#wr%twtubSZ4L5xL6;t|9Us>79s~_(2>$|Hw`|K*mH#kc|RePC7Zt`bOH?iK`TF#UGP(F5%m{uk* zl$gLf-Y9FMjk5cy3A(x(WgdI@hWG3fRVDN5P%b`hM!9*sQp$(Z+sNLL?N$X&3{+sL ztpZ;cC=m37T;fn>eYIgLt*8IZT#9cdYY=b zF^|*U59O!)k+wSk6+c+RSnH1vZ(r71{jkR}0Eg=a;>lI!WmctM#fE;T*1l-(?}xr) z{P3iYKXl#wU_vh0PwR&U!~781pBZJWomj2*!@~A{n6@Q~_g?k}XORQuHKi!vtn%R~ zZ09vIc`SLvEM`i3@mhPzEQUX$@fUkzQ6r);V@?#ZO`|YD7X{aNW^iUpu}0Cm z4ttKHqM2L6evy_LI}M}Y#B0`Ih{C>^{5pB#F>RR_H-Og`|NYZ;`cipKj%DAgeo`t{ z_h3d)ce)u58PJUEp`|@%;NuNQ=|z_0oB>a!F-w|!A>%2(H~XC5 z@8%(b*X`@&%4^oqiaFFn>1;gTPCv2bV!dJALEYo39=cOUPU=jy z`{_rnX{X=WZ@1^!HeGdDmz(JtJ$k9TTd%+FpKF74mg?%gx}F;5x$x%H%RlQK*VXfN z*45m0Nq6_tj?1Zk9oMDYZ|(WVkq4gd!|PnCJ}N-Jpyg!VYUZ!f%>YR-v_kO zt?2(o_pH@1-Q%uW&vnkrb!m~`b@fX9^egf>ccMrZ&VF+;H2b6_YPIpwx$kA%) zaV}BT_^2hKmr8aHQ%n1oYPsc~EHn41B<-M9jOA+Ce>PbrY*I@DE43t%e?0WkmEL|g ztTND@IMf9WMrVv9^AR89f|Zk8@VW_epmQBjZ#Nm0pPWyt?S$dcE*Q(#y4+*$rjH9+ z9&w`c)EVx-oZ#M)JuVAp+-dHDT7Pq9MoEYFIVXI);|P5%@{UhA1GC))3w}70i*Q9Q zXSc>}q8Cc#ggP6YVeu^#MYqGy&?5|PbHnh7J*mx?$eH}5WR?gSj|Oz3EK$Opd$&W4 zln5dp^L#gX#dAu$>&5-z6*?H%+6#W~bmmu=@#pY0mfQI}x}UX?-Sn4n2Il=$x>i!?W@Ihq z*I_!mt?B4y|1JI+GZDD2d$);y7Bcs9ZWgARlO;*aLPhN?H2O0Wqwi&+@fmtzj2YNw zl8pot&cJYgcxMftj!41@}J>Vvas-C21eD*!jT&EJRacdDl$>yeFpw4}8hTO;&t!mILK3(q@dSy!x)dtNjWT_g0{?feETN zBL6_HQJc+q4f_D}>==l&#erx!!Jiq@fmrjNvlfVkSv7iVo%V3v~ZETv7M#G*$z@+ z;v^OmTqJG+9TR7`f8!by+s70`-)lR9?{^eat)uvO(h*4qSl}Bn zpK9hz_oOd!6#beOfr#i9h(Nw4&+BA(c#PV7B7;gEWvJO6)>@fsdMFCDmXO0JjKY)z z@;h_s{?gEk$bH@E_hfg%({MeHzQHdAXhJ6B)sH;1NGw2G9xMM#PO^EgqwF(;(*r*okMo138=Z*F1F(gR zOrzo`wBbJYU+ZY>qgV5yp7S@?*=J~xhMPOmFn^FhigS;3BogrAWY_Z-)e3&H21j=ZxapY7_RYE_rSe1`5m68np}@9RvNHl zPa59wYy0^5sUA%RRmru^jJe$0bN;)DzN>X=nNQy9K0Q)<+MSSlqmN7AbY}Fdbi{z^ zPBMsr4$rUW9N1xO!a*d@L z#I+%tc81S;1L^jkMz)|QvpUnr8EnahEi*~d$qrs36Bog`+EY6fUj6Tp2kU-Z%vPvn zS9{huIws2jzZ2p%VU+m3X{XiGyd!lJl9p`%We1 zMup=7S(K39bljSeO9|9q{&Di)?U{X`&cw+5%);qT&lc}r|G6U9l2IARfa@OA!TTZj?F~k*9PmsO8 z?@E6#>kIZuoaBAJZ^v+?yd*1Q8;-R}8qOVQab%MgwN}#MRFCYSg3RSh<`#_0=4-Q2 z$m7)MN*10Rr-P7eTsup;5RcO-Lc6v4<>eIK?Dhr$QGEt!=`+0@gs&Dw7D#%zi<1zA7cs(JH(W}2k ziv5zMR}yo=xo_yf*@%=UWHCCqpjrtXS8H8S)RJp|A2<9v!4=j%WGX#aH<>~&a_w-K zbymXRY&fcTYM{&FpCCGl`>T;}qD2>XEp#23t-6`#CpQyg1L^(xhyI4PSr{^g+0tZo zzH?SPZJ5H#_L~vH-1R0>wNcv&sb^c2(SFILrj}!7q%j!UuOD2t?fleoRr19ATmv} znK^qS6K8gj`5e#8a{9;4_ELEHI-7XCxTNsf??m2-@2B8FYw7aVMLg{~O5%+U(jv-P z?9RH0?NkMt&#I6X%}p?Dd=(T<zC0Fy?XfLNl+mAj19yaH^WRegFm*B4EKhRyE27chCfAA+(dZq;eC1yTB>ynLf#(;@G z)6n)l=k%-!puJD8Zy8;_e;05zgU`d`+~lL9vp7t2l$u_4%vN@giMO2P4Ee3*WcQ&su#ZpsKEW1AvdsKnYPYlAXM!YAMl5hMFh+Ew_1E$`C69v&2%=h)|RupFO zPorQ1)Z^1oxtf{N4r#E`8eqe(b*jU;z$0A4p6BDff!_5^1;}2@Jnkl(-<#qhS&1Fw zkDa#S5#%B|o3_#?P=Q3=qc1J3kX0`fDB{}DDnWr|#eT5#3BairoNwz90Q(SsY$y!i zTnV!YzeZzv5%0?vqv>{!MrV*WzhD42#kl_1KqpHYbbMx7nViNvwK59GD zWf`827_RfaKcudyQ=g)n{^S4o4yQAUoISsCstap6na~@|q z($mwB+LIaG4f(9JjvmBcoYVB6>+^LU#>D3%(%n@Y?8)ZFwv)@%U70`PE`7hah=S{A z=nMt?8=D}sohgQ~-eu8Pfh3(j;wA-RK4&OQ&iW(tSrE=1@W+_G-0zTQY*Z43y%YAJ z!Sra9HQR#=;|$2MO2ZJY>z#X~p({U2ZMn|RPRhg8-~!aH#d=7;d^9+bkINPGGaXgQ z;Y^jN`l-aUNwPGmsutr8y7s!W2HndUjV|$7!GsR?0WQeY(fzlAJpKyu5!G7DGCxOVX#bSRb?y-O5ctyj_q zOO`q?Sm9OUF|Yae3NPy`8oA@7l|d;dq~D0+lHzkhs*^c?_SOlt+?|<4PTxGeh;}({ zSRFu5{dgsmF`SjMQ=;`ku4R1gsO!LcbVn`XHquucph5i!8tmJsLHcqH;_op3<}m$w z(VPv~lLaP>U&&L+Z>nJ zCu&h$qZ@LJD`tIj;U162CzrgXtt58wRg|=TZ zGs`sy9>STZ4I12w&%}DJTUYqL3ZJm2Ixma$$80o>Pw>?9tN{5xPDMUc17ubeGJ)^=e53$8r=8LVzC8h)%fi5 z*ee?aVSHYy$imjytf?Q&#OnPDubLwiUYU(dyu!Q`UT4e|UTYUByoNa^NzJ+%Y0a6E z&h}dAk*pDic)C8}3X2`CcwNf{IvZC^h;>2EAy?cICE`Yfaqct>^ZSQmR=>z&c_h}eUK=z)`bL01BktxfB^{)){Yr!lg`i{?$cW@s|N6QMX z@d4y4IZyF_pTqv#)k>C}DUv^G_+WH)1bPh9V?q=;nnzZ09D$y;NR5 zC#U8biT=fUd<>-jvA=~Bg#DCj6}~W~FYLEI6$7s4;@V1UDS22VZhSw-yvXH!rJu_$ zA1y{(OZwUp3A*EraYyL6W8Es`S1wdb&87U!Pw7$Njls*9m%UYw*9y+L2ARpU?ZvXm zYy|#l9*I7KSleYS$j_0v$yZC|)*^4XHjTorJ9B!D@paZ~7d^iD;^ z&^&D3VJ;S{%Vg(eALPBDH*kL{V#8UR8q!GG`&LL@8z0o1$-4Pja%7X3Yuw&aPR}oq z1_Qj&fWOz?7JAGcNMGSS_9#{r%e8gP&rOQJ#?|DocpSo4w2-1*mC`iA2kkr4cUD)A z;@!E}J<3*eFH7X*zuu_%kn_*Kng8oWFJwS-Y5J@}-YsD6OtnbPSnClzHxG-NT1qE! zb2T%WYaC6^t0TRB4tbo9x003f%4FS0UwocRKJJ(vQ%^AmIn`Vq7L>@C3EuE2jldFD z=IUnWB4|}p`8l#gmL2p%Ok2)ef7Zj}O%9#HP38WON{Q$B{kDpE;x_dCz01XdxK>i1 z4*Eo$FZQ3OBe)i8^W>Noezg!6@_O5+`@m;IBwU~H_nk;Dz?T-H_~(Z_{pN$AX%SF1 z(c@n8T%6n6TxJ#(OX3J}tc4Mn=|z9vw_MyN|5!=R%MeRG^jRcAtLkAWWnOj^`%G!2 zV!MFey2g=+Fw-N9JYa#3h5T7mB&h?K7aYfYbJjK^ALsJeS;{^smawLNI9i+Q^)6;I zwP$Yf`bIM1Mxpe(=8FqAIqywAYfRT%==(L2&+W<8n$ZX6#=LKGWbuFJq3iO7VrO3> zM?d=F%eDwy{h~v&wagQ5M33ZbW^u*%pdWK`*EG=MYb-h0dUo=qaiO@H`e56H2z=tt z4X?s^vj|%m+oVX$#Se3y?nVGP(8pu*5PGS(40QM{W3G%q@h;{I*Ga{PCV4n8ys3o-3u)S@ zM7n$M^Z6)(b2#Le`;re0vyxZC3gzGdA5_^LNxwdQo%_k{4z`r~yGvytKUZ}}N8(Lk zDke_PMbQFViOVmM56p?a6&Zn$IjQg-$U3g7x$L0R;JJaHpH5L|!dmh1j2yh5%g=vl ziS!=oi>W-G!>j4Bu}&_ZY0Tt^RjCB6;rkgIflCHGa*y-t))wM+xLmdc_;9v3g1Ir| zDBtt`;9w2kc&3Q50!rKvdQSy|1yG2D^LhTqW%; z7_ftqnE~u(hOj#**IZk|U6YP;?f1OSIe)8E_xs}SWuu&qOka#~5Ku~eQm_o6E^3^&aTXhF``Wxj)Ss#_%echl4QJPfmr8}Xuk9&$UF z%eAp(@*>6yiRR>IXQwdNg`UKbEu`9o3UR%}{I)h4yx^K`g%vr$JMAUoL$O?b>w$wG zH8@@`6;3B}F|t}~=28?(o7tXl4-Uud)+reI7abUm&E;owvCI%JOgJBo-dl{=%(ErC z95V@-Stx^&ys+T!FuXWrM6Y&vsA}6r)@>=3(O*1q$UY1WLXC)dk&DUXE_3de%eLuW zbb|9ff0u%o?tJdvw3XjJ7R!`V9=LcboLOi_Jj%*Nhl&=Gm{=;q%{?%Z+@cMy{{ZiY z(B^F<(yL7Vtm}z&&f%D{+lZ3Axy-0(E1#ErmvN6gFeWn$_c^ZGt<6P5*Vb}jN{JlW zItu&$*#n87*Y*BqL{DuY^{4PTwerDOJ{O<5reKFhE*5-=5j*mOO)mz(W}6mnfF1TN6WoH8|1VJ#I#!EvnG+>q0g@L(_v|5VF%Y= zt1&E_dCDs?(V2ZLf7XkU>I3cZ+p7TB-_hbPn=G7~UWLtFj>*@vc37RV8mF#nk@<iXY#U2|qAUG|taThB zuUCI|w45Agi=t7hVK_!_oo^Og-KyZa^O$USXoq>_L1@rkhej8eqq?LL2#l7SA8p73 zkmH-6MPy+Hid`yk{zHs(K5L7k{^W6<#^Yg4`Y7MiA9tKN-J2b-=w<-x4)NGsoQbXc zys=)i7;n*!wj%)Az2uC@IiB^a#GyGy<)N(u`d0=*-%W>^%UBPl8(OoPp23dv)6ELR zByvxiLNYPsXBGaLA1xV0c33{1*-5clx;ZlOY#sfE;Zd?|qAfno4u(&CEn2rGr{+j* zj{NCw!M3c2kb~Pzk0Ck7fmg_xu8x*~TXq<38Gx8BT0A&Qe#$^Db#|<{=#+Tt5`^dl z^f126!1<_3jPZ&U9AZxHupo@{X2wPoc{g%Qixx#oO?oyH?*^kwo)-JJWnvP2bDsL6 zvW>aGQ|Zt;K|XOg8HldaDsgXRlq}cV;Y+(f)SRV71HPY+<0`RY&{6rwJl~$oL2hUr z4~wz%?tLbg_w1O|9-yRWl^#RBPJ_YZ@{aIza*s)Z-WJ>51fnV5pFj}`>s%~Rh0{Js1^KD7P2XmKI; zS6UW`vd;8c*2%<$R;%)l~>O5hL!cZP1B7?@_+aD(N6EGMbkv!U zBc96lQ}~?T=KViCM(*(a%)b)|%L*-7XWkFBs<3?-`Ntae80XI3svbIi{|xdD{JHMO z$>tvp$XywP#S?iy&t%R!@5A+)8b;X$zLtq^aFOf*7z{k zaP&Y2V}z={F{Yu$khkHGq49=ch8g#JxSc(gZ5Xw|%D61CJb8fawdCX09o*h^?c4il z;10vcWp51HqjL?b|Nhv3*Nz#HIM;F$F1~%5p z)Jna8S%vQ=>*PpDjM&eLllHe_#l2smJRjspcN+UllUYNzP@>d>EaPH2ba{mDv|eC38lXyK0R{894qDj^gQOoJK+9ix^f$^U-hX20!K3k#GN&a93`A=m54j% zKp(CWmc5kN-xm;uakg|JV%&A&Tvq-1Pt?J2H<=>n(fu0 z`DGoBB=USAi{qmu{XOgTn0Hl+_j7fuMJJ&9V`fO-*Fpc5=hSJ;vR+5;P6K`fl4~5V z#nRz=<|5MlJX43a)0k5o$FpnJ!TfERJH3Za#WZ?yo@e2BNEW7j$->Jcbh>WL!mC5s zxJNc|Pj(jjII~ecgJ(VSvk)7^b8K}sV%p~50_%A3lj;85orTK^X3{s$LP_%+_DE-8 z(Df{A`7H~7kK|Z?l=)DxJhNu~W|wys5;>lCo=NZHiEKC5riFYwZXsJ()9w?cl!g zWTTs%v|?YCO;a2BKG8~EwzZNPMJl;xZ6}L&*vR3Xw({(Tqcl2YDYehpOJZ*a8R<;7 zPoz?^gRSLyoQ-@P<}69CI>^=`72>Zk!L#f#i5_1j4i^>3xvOBN4QsONOi;Cx4!Bfu zhj%Na`8NgZyD6~nuL@Dqz4-gu3VBBN+!nJ+xv;xjX8S9!1150kP0q282^L>b;AjVO zS~XaocQ2FK+>e-#E0?~*d4{^LQu@xQl&)#zqUu#8C7zWMf0F0)K0dJRPrfk23)=c# z7?|RXIdkaxIpm8Cbm-qL;J)-M`|nTr;L8+dDkl5jsJS;TW->qb3|T6&Rz-WgQMS+< zH80b>_=vd#JDF3>f4{ihhb)8-^8fZi>l!>0xaN)fbG*@JEWM4tm_;4ToU0w)$Q$g1 zN#{J#lr{R~6b>FrND#4@Uzxa#sU+e&a}2&rIfUoJvKnL#fO$N?|q{8N^EFHzlXyuSuy`%0H7- zY1p%ceB(m;bB3nkg?kD%7jtjCFBM<-F=#q-6nm$lU@pCJ+@l`i>ja-o#q-U~o*tiy z4Ru-L-s6Eo~;R@^QX(>1aer^E2Peb;U&d zn8#kAeE3=AWA6Dpk)YCJi}F}>+$ z9FvdAeRM!NILYLpwz6WnQryfer1uCLsjOxvE3P<7?^6!+Jl&7F%-xnb7D`FcS<8;P-q5=ao{>z!VRy6d1R*N;JWh(qneHM4Ff&ty8&tZ$geZfbIx##gAK+$^q=mq%ix$r`tG7k)FDXD(-lrv!f51xA8`ghx9WtBj?*=auLbia5}?hwVp51 z$NS+t|E})k32Xk_zO~-;8u7LGOgxSc$Ldw#sNPfqn~UKXGm5-nOAXQ=Fhlw%&!Q^G z_XdO`{SQ79jhWFEz-RBX2G>{9J9d-#?#>#t`oOQNsljgQ_P)-WQ#HB*ZbIex`Y53+x=45dyE?!|j`pFb{ z%}&L%pfuDl(A}8An%RCbz~A^>c1nZgN`8;X6y&(2VsRaEkG5&3{*-^enu=dM*V>lN zj3L(2_8nq9urA#$yYtXT%M23U>l+Mtm_0S0H4UD>eaXiQV;)j+SPwmrkA-wLmLH|l ztWN=sexi@+FrS~VbfWT{cUy~m1n@b!w3%L0U$Pw!*;Cqv+|oaJ*m@x!%lO)QKC4!I zHc$Ux?)$_7T;9*`-5?KrXOer|@VoJbwrO&gGj|Mo53My^jPGb{1BG!ISU@`X86l6uKdMYo*9XE3b~ypEyd1Z1(Jp*K>_`Nr}k1 zj(A#6iQ6^~P#4?dG}m|Ct}0=sP$6On`&+g;;sV!pu5;{>HPaqBbsSOZ!ffgN|G5?& zkZ0upH##b=M=G%~+a5`A>}#Q`f4ivz23V1qoJW3fl@j3pTTs^ln^kT>kkv(4$jNV>q>t_5^zbq}E*KLnT72SZsi2=-hP zn);JZnG=lr+8}H{!p~I&GxH$?&7DI~$aQ3khe3$HM|ZbVFbWi8A~*4MdjHo;8;q~L z0&(CP-HsLPZR2YslfU^iI03HfbT~a-M<<*Xp}~4gb7#*>^#nAv(lc{Fk4IJs2^`Bf9fGa^q8E;ui@WqE$KKZWB+SLCJM=p3~;Aw@lY22?3#^avMetA z__;j`fApfm>}fUzbG>)(4*OJoWx}#8nMHHJbf^H;lkMj++ZVF>iXW2IIy@piK+1f=klqV^70#jyq>}rNP%DjpqVi z5ZkW+`3DN%IFyd7reEMuo%x;P9A$v(@6zd4M>(PDBy&33i^ICkGV>(+VA`2tJvk87 z(rWM=SSjv}nTfs37YdI1cVn4b9N-I|XkWa0<&B}s*_Xld{Am*+ux^J2V;v)*;<{;3 zRvH>{{OtCX=RlquKhLG&!W6DSoW8(+M?O|uEI@6}`7z(}F^){g&@?+)@J%V9>pIH( zx^}X8kdyd3c9L6j6>wcn&(;J5e(4qTW}D!ujR`v0`Jw+CU(~ARk5^lm)w#q6u4Luh zi#2GogpO=O1pM9Tw(7)dyAc7$X{o5WDveorX>i?`hHUZ}TgY4<=v9Dj_Y2TycL9E- zp! z1NH!X@kWRJez;0+<(((=8@u^nL?f;ZlOv$^j6f0R#w@ax{+zpf_b`jHZ#sfGkMtrt zQ-f=}|9HK@ngZ6c3h?@DK59?*Ew0zNt5Kz~OJRXBkK z4lLq$8~r8(y~0BAYF{XF-iDxaY6#kELf|#)KgTS`seL;5AEZkvDuMnI=G~C{ij-`$ z*vj$5F&mdwaEwUIK@GZ*zRgjn9d?k7Tf(z+9~1SqN`<-9mBuVJLpGZ@Jl3)}}6U+?&Jw z@L$|>=abvZB|})GgLh0e{Fdfm5pyyJTxG8EF!CT_JkKYe;_y(R?nUmQs+~ezm;7LT z@&(@Cbdo@q@&3L^a^_T`bf3$tie5>Q-qwlh7bVsoV2mR0?{9htKJ3=v?qNNik-xCJp+{Q_J-(%qw=8Gg!4&eHADE|1_Tq34zE65) zh?2Kxc0-{~-b}Xgu0riQQK4Q^%|u;SeM084ub^LiqRgk4F?MpIl$vQJZXsRAACzeP z(h&_gKjzO+p~W;M_OjOT>P9e9hq690C zSTdG#(Mml&xFuj_{{%E3i+cYqb79D$e2&gRKsb5$C(MjkNG9ZT7H(QIf4jYjI<}RG zdebC@+HMA~XBF$lc4T3@>10}$Byn_$muenlW;UFVX+4!FzUu^Sx)Ot&l+ZO-;m$%Q z6n$sCH75k)SjRccI?$LjO`8Nbd%UCw)X*&&5`8NFoLn>x$6vM$nQxUD>HM^^5jqvRjy zDrTn?_<2i#cYl~5irm4W=_at(m|`yX-WU4%u^voc`~qKSmiwanFkjqR6hS5{0`X_a zFZYN9xR-v~BLXhp$tq{Emneznthdq-M)pfJHkEu*KEAU*&T=_@h^NTyWpMr4f#c66 zC%HDLlN^e&lpO96-bOVSX4e zlf9CCy|DGOF9xt5YRK*gSa?NX#!Ud&)@eBU@&6k)0f$&poRWi_az~ z8(JmPH!E;{58tb7=3cMzVQ!ZnKHu>{=1D*7S8?x^!u`|62%LKqf$f(xIQ5o$9FEVy zVPqFMe{JN)&%aW!m2>Hpt?3v(kZwlq2YNadpcVTRz7EfaYk598u2#z8!Ol`TyR%H| z>m=`6bYWe|S^74tls5M&MPoysCi^Dd@*`t@m1KL<1%00T#$$f?hn(kKMvwL%1kI83$zzh19Iadri z$3CoA?5S#EFMEoWa_OFvRO9}A1bcl)?6Hv`&RrwcD)1($LeiI;pm>o9F1wO%bn?gQ zC%)M7yB|J|rT2J+FNW^(#b*uoby2*QBC@APBQT>auWupiIP1Ajo0W!bozu|wDCaS< z`E~8mU|yGdr;`QDs9+6a0oh9Km#)WTRV z$m7p6!Czfj|0-7CV@DGVol2gOuI%{^%nB*zUYPxRPO~|m?TNra?rY;7lYuQ~ZRmvt z1>GYsc5)g9eqin83VTiW(x=JyO3693q&waFl?6ziQh>panQ8Ha{Uxk{SJ@uNTyV*F#RuTthzYyh8nJq=|Y*_2V*fO1wBt(8;+YC*|VClQJ_! zFK2#tf*swAix#ntzmUCW(^;E8titd6LQwO42&VCxBKp!@dpZP>3i5+XIUWz7@7~+6QHf}L{n%;6Q>qi%19JzeX4?pRz{40Q-W6l$WobOXO*AHNS z+}O8z*~Pu*Lb8?{oKMKHLkW^(q|diEy$9@@XwYAYjCV>jHC3TjL*^p!{aCOp1hzJz z==OuYeD2$xfG)-eG?bm9I?p7iRw;&B5GdbT5<9-K^tYuL1M0TV`YP7=?N+@15(M$Lz_%UaoDT zuFiY<|L}~XyIY8@vPfdDcwu?1a6GI}_xB#=$n-ap$m50bJ3V46U$aKF!idV|xp89c6QO-Q#_Ib#5F_T)03&mlaC!&{yBYF;bA1CrDm1fdlXNk0b!rFBs z=EMHRoYO9O@Ne2drZ6YE3w>wDis)yIWlnA)`@Gk;mBTd(<)xK7UCHEqcBkOT**vsa z)lBBnFZSmkPo#7U!^$T{T;7p~PrEwExe2B6gRfIQo*W{1%yzSLq4>SEnA9wh(OXyx zw+_QK)}dBz&Sx*JjT|Z|mGsu0=#UYP=ls6STd+^|a9jCzWRbkS>kiA4VMw{1f~I%K z10FEv*;=XW3G||~I2_v?Qqf{&F3Ooh9aF24x$3ODE5f1fmV#Q|tm$U9mB&11_?+R1 z7hA&6m0ra-b8?+0Y-Hz%5-C6C0WCSlS<8&5bu<@~6>X%>#Ug3<$rD9U;duLvJenDE zLi(7?zy9POk9cBKGYv`$jkt1|ee@>QGB~S5w)dy6Ffa^L|46}$i_E7!)j>vwmC9*y zZ3$8I04^}%W-9rnVeRG1y;6xj;fYsWI9F{Xm-mL8-RHJa@~lKcZ+f5=`M9D9MzkE4 zi(SkSeppf_XaDlTd0uDwz*H25u#VlSos=1V$+F$-^G;-LFMqC*KXXyT#ZrciES2Zv zK$Y~?wV{WxF8hX!JuF2PUqnYdGo&^#FZhuW1Hb3OGq$x%EG-hxL)@S4B;QKTaZ=f5 zoJ+Bi%MX};O%7|ST{!C8Frdd+UJp6hG`k83c}ni`MHnvRlfxoMIl7~zZ0N?d!vrrF z$jOHA{jvV^85+A5^pus$pxIt{a4-zkt5RUi_tT}E_w(Hn>DI*qPF@3S!olmat$+|qObZ#eZZ+SmBk(=Z1{hN6TEO_2ga?)I;%_@_%tJ&Xime+5` z=U1DHpeOBQUrvb_mU$v#CEXPo^1o61{~v6ndv1wbY3zYSa&STQQ*b;Yk6tZ$1GVMS ztSh;>A7RKLC;R>ZJ%BAc$b_cl@}tCq4vjFhv^8P?*OAxR6Zm>SsqA(4z@=Dni`!Dr ztOdF0FYToBgJS8~g!$br;qbFGqM0xKl@rWF-?KHhJT zEWPRlO%3`qc9G}h_Z{%Cjo2iY%8OoJxW;kjVO!>m&(346i>35-E|Gh`=s)GSVT?DT zoLu36*H)6OB4@YR106?)V=BF$(TY5@7}Qn{q?gIkV;ryeTx^Im;5R-;E$rHg?PhtY{~fmzIe&$GvqE$TKDz@#j?L5Pc*s*`i3Y zR(WG1&(*$NHsIv0JUU6*$;hGPb6fM=gPdl(ixI}%^i-BxNQZ8fQf-?jc9I)iy@-Cv zm$_)!tfh=otg?j4Q=wdnoy%tcL}{T}i9CEt&G;O@~d)IDcJ)TPgOd9HILER3@scyGvQ*YP2^!tGvC?9+JvROdgg1GdKID=bOs>MdW-+p4 zqaB7!41^PToE~AUsro9^frDeD`(is--wQ?44w36=Rg?XMW%202 z+VZLmm1sl`v2d&d`|ShpJ~$o|Lo(5i{T7!G#>rF@J36aYqc#0;zrJO_X<8L-XC0I2 zW9%@{KLCzL z+F|G6Kx`#1Hu3jN))lJYyf0d&40k|WVIXR6(!psn`6>P$3;8-4l|3pN217MW3wu>2 z!tKbP#zsr4*37C}NnUlD79Q_1uu7^}4~><)W=fpe&m3f9Jaiv2&^VaAoAkIfBj5U! zez(-Oyq_Jjm|el2*EddL>)W9#f8NF);_*X64Pqw7B+H2Kvoq zzV_lMQ6ICz^TGgJA5X4!Vg?p#D$)K|jO=@Dix=uZ42a`>sLDdUnN?8tix^gy|a)-zut)c z$K~)Z8+;xfi21+b;iJt&M{=4Dbz@{zb2}`UOrK_YJYBEMzb>XOYs z(toBcWKs~m7`2!~&uOn(^gjkfOU^-ixYi1ULufp1X)~bMTZJh@VkLp&+miG^6muLK zS&h#-`QoSd{yP`6LCg0+Q0H@;?460S$_fm77$udR?2wqX8hv=3kE%E>@p;U$i;-5P zb{M*YnYlgb{XCh0LUN;R_H#TGdj#-(i}a#*V?qYa>qTi^rO?w)|XyLdSf3r+M!)1 zdT*C#vA23A1|6=#zkkI^mmTDJvjX5#iyjYpa-XlM!t>s7;(g2>^)@jdoc!Qgjx(EC zN6dN@ClkHxVP6@5iq7Q0&(q6xs)~*-a;!#M^d3sT=O}WZ(=u`I0N>A!u`+VMEt>Lr zCV%2{u|E^-8df18EJpl8>@boX4yFt%LX(CD?x)2*pvM`P@v?S_o@ zwT$DvUM8EFM;huMS?6YIJYi@w+tuy#q)x7d2koys3q5BDe(i5?JiOG9-?)a`_gAHc z$U5H)^INwxSZr%-T&G)WsOa&*2&`6bmY*lqdXcdArjLEx)oM1U%GPEaVcc( z_r2ROa&xOr9F|HjGZ zJI7_!isN!XwBlD7FZDxX#rN%TS!$(~6LWMjC@oe>EO`drf*zh26&`+Yz)03Xn$1z- zUmtpKk~`w^6te9_^a8McbI(NukAGCm$WM?y0>v4auevzh!{dFBK|C5Caob&$thk5Tj zPk!gdnw&ZtfAjppbV?QuCuMOQ%EFmVbPe$Qz`t4!>b1y1tK0myD_Pja^Nr?4_I2)N zE$vDszAVq?zh`4*0lf*V>nnIZ9de%hVjMZgx~!3qeKgGE*;PCC?T*Vr!B>8sXXb%E z^#5?~YPGt(7;ZaB`h6u9!aQli$I zAg5G;^+Bwycc_%7zndVAxwmaTSI8y5axz|(QX{xRCM>8DllUrWvbtP`gwqqht3njt z%VgjmRrK~(NQoQI-RCH9{Vg-BPn1cO8SB1d6=VS_#W1;2+B4_c&a+(pY+Wfbu!!g~AqT6DY|^ntaLA6(DT?Rd@)6Kne-u{!JTTYQi@+#5BxS7|@V zAB(nlqwg0VuGjq#(TCpoS);K*5y4Dn4JvSIPU4zjI4F+{2 z@A#0lpRpP=U8cd1U94A?(78xnu?Ej#K65|#4?o|%kSqb~`{$J!EOjNX<*Pw&@{bi~ zc?J=rfs1tnj@m___W=6lcJOt!vF<)Bf?1&&d~C^l-S!b!(2-nKhg9V5NJZaXJkQ>h ziq~CJF)l6@o$^yK;XXO2*D3h2iTz?^AD6kN;YkHEOnytlgjMtlS*9Q{lV=?fny zJ%#7U`M|3@Y_iLT^}Bp{4PsWbZ2{{3l@ArqCD!+4?Wq_21|#TK;yH?4Rz7|omxn3j zr{;Ad#~4ShaY8^Xz;Sy=DGozdRh~estRm@>sj+ z{o&t3GV(BDGqc1R(c{S1vEqL6a;Qp1PP3NjgRR7kz07l`*orr~!s9*3GHz4KzIS}4 zKHACc6=Wbb*ocf*$*IXIajfqo4_;VG8u^IdPrArOCmVS<*j7U3wUhacY^7FDM|o(c zlG7jTrE6PDsZSqN+Av#bIk%nc$Y?K5W-6u6C|mXeI!OIQE1B9^DW~aa?6s^y0^TUl zcRrtsDHUS!vPv!`C=lDl1XD(t;#%t}c{aXEY%W*Go;u~S)`nS~-z#L}=t>FW=a;Ri z2E)xNX=70-m#0>U-l{^{^;2N8wnCoj%4H<~Z|4bBGM1mu{81uJ>3MwnSb;E4G9{%Z z@ZrDzeXUZC^Yeddcn-9Xyzf;X_!)gM>W4R0^87I5Fmv5LF?Yk3XNVWbAM&|rtY*IZ z3LiYE@J5=m7gq3WsL4?ublBhyL#Q`<)tI}HNx$L-AG9g)LB?SE8(*^)(2Lok8;;`%;mpF&z+=A#Te!Dx2n~)-p}XpqhI=bMR}m2idc~}1K3fVtqZV-* zdLdbpJ4ycHGiw3b2n^3+^`GXIUwSbaXn z$NJ`B&%u2Bm70$?ANgEo=3(x_JX|s4GIxuaa3Ag%cADE5x_7%~*tj^+psser(A4^s zYlz7xH{JC{$t`kECAaf$V%%P|J$b=<-%3+3T<>^I2R}WbC?%aKVG`U$4j4!S~+<$R?g3e7hgx6$Z?$*cPU{pMulpY zO3Zv`kIA!Dm_t6MU_KcOXBEaRwMR&aJsu3=+A&m#TVYBZPgY`*nF_tr`LzeRHay_K zQ!5ANmn&gg!TeLc&cfYFm?!Y_%b8F1Mv1Zs4sg^fvCKk+Bxfh=`BRCn?RZAVui5g! z9<|;pG3S*MiF-rQpXhv z%6~KRtdwifo5zB2k>_7N*XZru#P9n(6uXT&Y~^}wL}&7a;X3@>^cA67Vxehpc^M z9J{c#P)~=tdvw@M_Hf%V9cJ%gX6Zoouej)NErva!m)X1WMhlDA39!=Zm{+fZU6>v> zuhQRGhk4Vv+_z=u@wbg0kKgLpyTf(hb7qy;>9M#=0v7SC>%=)7(#euE=$3_kt>|UU z&%(@kWDwo5kb08q!@+dYG@+}JfB*MlHYWDUf*skL{O|N+)g~L%Iva15%!vM!N#`tC zlSJl9A0eBg=Q(f>x)~>AF?I*a2B7uoj2M!M88!Se&;(mAJ$%rnKj9o6V} zrss-h=80FyjIZ@WlSw|fPp&cdj4$*v=(2mDL5tdCyW2&w7c~M?CvmLfm~={;ik=JU zwXm=;t{$_4&FHrx6W5q$`eXJMpm~o1981f`&w0$p z^x$0VZX+I1f2C5s#Z*b=#!9hSUnR*~6v+KbADFEP_HFRP_XU2iIZW?& z3qMpw`6BBCGnUE7*piDodo}`{awCv&GZJ;Caot6hU|S2i8M9MiHa;CoI7T-wP9-m1 zfYtwU+~xc7?q?qAZZ4oFr~p4Fbd=AH*>mKml8OQs(OIjc#`#Wix`1x0am<*0R3`Sv zO%c`B1Y--UWKdtSC`Xu~Oa|k!${(2LhmtWqu;84vKaA_hDa=wXqBEG>LySb=X1`Pn zu1)@fbA%P=pB|p+7}AHoJH8hYPsn?&&c_EW9apCdaB3ZUOYU@*4?msd>0)PbYt~UB z>d?D&xT6fYX^Qim6gYCJQiRu5AI#+Dy)^Z*F9z!U@zT-{8s@6jEcHd9qaPX^qJQjO z1ap@o&^{*;i_b)0YwZYZ_{I6Eklt_GRJhelL!BR~m={HVaj!49bcbs{MFC9a79ib; z@6GW7`h2>`RPHy{=Q&HGab0Ba*iI69qlc`!!?jSF0|<7XNUEud%gb}H(9 zOv3=LbU3OCa6h2{zunKrfGcD{crO)h%g6I@tpxw0m$GV!Vis~r!ke9xh;H$+>ZuA( z|5c&yLr2s*paQI&@#PouolEG}^9{u}?v;CbhoVIpeY46?Jl??beDeeh?3xIxa*k6T zdVHVA++dC${R6WxBq|#nreq_nCK(L!aqY=|wWNPAaK1vlnQVyX8HKtt9aFp8CCISg z1nJ?Vl^Tv(@oJbPvs#kb``ZzdBIvj3>WC?>DxCl12*&{`EO-_Qmu{g@#?kXv6^d4u zLg9Wo6s!9rpnOUKj=g0*0r$bC921{4;A}EE8&N#Z|CEpo|3Nu)#b;v`d6g4WnT@$X zp=E9WP`VHo|D>t2!L?*8OBHG@na2BC`WYim%Hlthm}Gh5wpR7(Rqz8*2w|caW)?jE9otp0wkkTa)Wn0M0R7=29Nx-*CJPS3{Z+-!WSlf!4t zM4e8Kh`9-B#T$jXCtXrW-A&X3Iws2TQu38_Q$L!TB!M$d$@Ad}vizbF#($jPTi+Qa zd~a-5F;A5Kua50QaXKOt9!<#hI1$d!Q|4q)xkN5W}vMRy)-(`rslk6^VmVw)q z^5<+DNj7(qvRkEc<7bsjbXU;xZi;d{6IhN>z`c(j{?z&4+G&5(X+v)<$Llj3hhFm; zzj#K2%-a#nE8{x;WCW%(iNFm@KI>!nj0dIT@3CYVyK!u^PeRRPmo^x#)kNp57N{CeVt zoG@Sf+tm+26aVux`l0Vw^4^#D{pUrXJNFuWIFHq~j>Lkz2o!Ef!<~RM=1j1!@MbDJ zho)f{-N(Pp$isqg_76p~N8lmZZd0;p?gi-c+)=g$sAS0Dtm+Ry;Go zT2p%V8!9mSyaGw@$)1lgVXqm-F;BTA_mDHXSILzZ3Y==i@p-%{2AP@QV_waA{kB;`Igi z^pe*SSb)i;%nP4cfTRyD;uG0X`hV}tYjP2@EzXkFx|4W+F+o1}&Gwf}aDRje>|U85 zb1u2Yi@vxx#E))OALujKOL5y5Z@Cr<3}EeMas--^8Jw+VUU`Q|6zpLJ^@((Bx|fR0 zWKSb_?_?ZFgL}txJetXQ;w7EFKiFs4J0BYt6`-P70W$w)e`2zYtY!xHqI{KnrPk&5z^QV8D4rp?*4vYO!Jf2zDha)g&X#`pY zl82qZJdc&^UEuzAm}5HnbIs$JkcJMA$-_paq4Wat%75}b*;T+ELiU!F6=3^~0yN5OSbIBS*(@ha^>ae^autR)Tm$EaAk|IQbzagr0UPfAS9hg1eJI(qt~uBp&o%I)984UajrqQ;m-fiP zE-Afk}^}tPJ)0n0FHY!0XU+d-8@+2{HjhFT@iE{oH^X}Jjk5jE9 zy&@{CUE+xMZB^Lo6Ux142)1k1;FD)4yf=hmR@YE0dacLP1MH&NfoB}=)V=LFWQ z+4o5hd94-OnpznV>VzrZIiD|7!u_fvs%k4SYY_Kdbwe>QAe85wp{P;7zAle7_`!KB zkK^&Ug9#XPQI8}tmVG%!kJ&`8@9)`|wun7XoX2i{;d*~hHZF7CICfm2#zCI{b6j3A zPoXYvWTKvHZlX4I)5-Um@p7Vp(V@#c z&(1-4tsLC+q)&4K&(6s+jyX+VB**D{oa4_GkwpzjVy`V3)VKuk=+1tQe-p*iBT;M{ zI-)}!9n7b=k9F*s*|3S|X-e0_~w)AR#(__vFdI(s@uTb&# z#C_MmCcL)L9P}y4#`5``*VmH$?4FIWZMbjZyp>6Qu`S;d)ho`Y*A!~kFADWhC%s6| zL@9caDC-gvB|AG&rr4j73FS&0wsmC2gcC+jb0Wj#1p9i9*xNW1gNKBoAd+h^w@~ao z7>YNXSHFHuK8^BV)IJm$SHT2?hk__Ili^5;jC=YQdT}JmctW0ko_KW-%pe~$xK1v*4z`f#ZOWK8?T(^x;W%8Fg6`xc*UUDPC0|RVfPKOD zF42!xYDAAf=E+8xOYd1FqU=DwnA2Cr7)Gn+Z!wjSs-BMc*U7_r>*GjnAvnFn1gD&~M!F9^fEz4X?-r|-w@fA)J&?RS94V~N-7{qmeQpbBPj2y8ju-ab z2}8wFdMXFx(obP7`%jSvWUg`Z9%0xq#ei!`^g<48Bj*~@Ygx^U=WpTI#rJvVe0uR} z(3?5BNLH46B9Z3;F>_hp8^xU8ITq5oCcTy`=_?$mL9Ha_dXuLc5N0Mt_e-Ql8*-gC z;W(X0|Jn`qBj@p4C!$2EC3~=^H4N>9dEW_nNbS{DW|)*o12yw-FNa|+>-CMl=c083 z3z@f?*$M2!@cP6&ZU^#H+qrMOO`l_WrCh&5e_vG?e21ivRby}S5i^kkr7|l6kJ-H3)>dv^4s6vW%OxJ_@#$2dyGCrKXO~O z&7{xupE933@0-`;;K*}r$j(I@V+(mbw^*!n>}iap*Rnwh;?2l2wrMLa=ZeLNu8MYi zUOw((?e%Id&T6fB=2a=1$V>jm1!sIU(gnlci=O$vU5jNs^V8jaqZ5MMq7-~W*}mqo zF}F;{KIeUVJ{;GM8reUX3)74?GR>)6svjmVHi6vkp%i?I;d7)h7cbsd&B8r#lsw?J zKI8${F{hjU%KeAwIVG<*b9ERBd7rCV<>E$7=6X*e-$xH%@&M)(ml(0zoX@+ok!D-V zq*FU@Its&Zva1ogv3a-I&-CS_V5P5j;D(#hS6XnLKJ*A$2x-!m?R73Zuzs zhULP#cS~7Pi@EL0Uw+8@ZTSxaPMGJR%a5k=y;qqu4D!I~1aicmjo3z?MPX7)`Fm=) zOrr1d)JFOfn;S8#VIGohn9H&EWm2P^2fS=FxWk{T)5lzdwdMWUw@f1AJn^fTo?HX# z^P}^zs<6GdA1IU$Px)N9XwcKdh+E#wufNz%+BPVZvss>Sc|u?3^c0*-BcIr*y;#gC zmOPCY>OKua(R^-H|TS%>NP`|?VG=kN4&uCS7$8ai5RJTU7}IQEUE zCwCS3;t(t8$sF@L9oV=96;rL&q zy>(Pu*&DVUsQc8YQ7@W6sSC7yZd&Sw*WKL>3zcc7-ePsZ3Q2&vCqUf|lDZq#c4}CG zeE0mm^}c_6|9-R9tSK~vGbiVqz4x=P=elJl_ZGgBFQ(TlVW=I79|ps=3%Mk6F1t3D z;rRGi*}K{nC+TI&p)c>_MSA@fl7F#{m#%U4_{bdI;+^Du$lpD1H>1+9I9Wu_CG$Wa za{Us~u{Z-ymz3d?DMkk8*de}C5M)Ur*7l)q%TR`-zA@5nu`M%a$a9f5EVIbOf>82G z%i<)gqCG6n1Yy{YL`M$+;BoO~h&LnIHX82HcI2wK4Ya4GSUr znEg*quJOw&X6u&1f=?IkqS4akL@(_30yPH!~COlgeQE zb-#qf+wrx5s2Z7we$z6c@G8TBRnZb+wnu2kK)Cub2lf*AubK+?$K=TJob0f2XfS*d z$O#(B6_O|VMZaFf3#5vd2(`zQH>)sgJ-vtI$o?)dGgmHJ zrjD`4w)6DXDH1U_I1_~j%@{QLuuPyAvW|5iJa|4ol2;nwU5eP~I7uC9k4FJP=*aUK z?3Ic8f6+I0Cq|qX+2eT^a)RaPdFn~-j66{dQ>;XHae$L=09sDbz>S>4w6{TLIm{zoS6J~HExAzB`; zu*JpfAe?6{e==*{M@(k4UVBJB8ggj*K@HjJ_3`e9% z8wbof9srBUe4m{e@HuDZ^DtJNn73QLbQQ+$(vZL6^?#528oAx!wde;-qqni42K}C9 z!tEV%jn5yJIhAZt`Yniki;2h}Kb!p0jK4mT>ntXRyEcS-dE{Q5=pZ1+y5L7N$7DOa ztU&)Jk8^JpxlV60UR{otUZ?0)tjEuV*TeE&?S#kkl&7%!0j)$;nhS%#X!W5x0;c{i&d zytN?*L*CP8hZzZO(P9~557(N3coUk4ts673I+ota({b{L{OKI>n+{i*i#m*X$0=qk z4Nj23o9u9VLJ)8!5$V;K^V^^dQ~2Cio#TMcVFB#zPsGpB8R+9$2Gv`BUgQ}kw^@a@ z;}Y>DjlRM+%qt%dE7R!pTf_ga0k!ELG|~gBs zI#${rbAT=Vq2~h-JT666%gL_ad zekR~pbOuKDGs7d`u#9Wrh}OK1KE)@{UHu4$x|=cM%wgHwn%7SZpEKRa&AHRdx!H^* zk7A{U!WJza1><)!=7F^)pUC&Ael1q!lY8}j8-Vy)NZy`+rlT_Ojk(*0 zuf#~zQafBY$MfmR`~6o2fWvhgZi*cRq(_cm!k5 z2Mu=f^Bq)$JfOr0X4+$W+h9cAN}%hJykQ;s9G&9i;#7M+7Xz`eNg|r|&%}_`sx=RTzsc-)_b3CrC;W; zU4Pl~dXMG_Lkx|tPSiJA_3Gm7k|_PI^f-N5q=VsQtkQ5f@4Y^ER~y6MxAQNqjyb4r zy{?BrQ8>y_$!)T0rq>Sr(0L(l?-!KQuR7I9Khuz}pV{2`VvUir^`rYIx>cF9PH$VU zwf;EkB8OWgG7mIKCQQ-Ez292N4M~vbjz^@;eb#g6Xgu~!E8~Z;AKk2#hX;?4P0`6G z9kT4^4oR|@jIIP}7qnhUnLIwSC?+C;$E@}qgWT}TEh|Twkc6#106f8-PcK0 zV;O7Z#aEdDQC*ED&D40Cug2IFA*}0$u=k0co>T0r>`pHL>qtg#?m_>}zWm2(IKN_V zD)*#QKB+N{H34H4H54D1J=l~^oiXGcr-agxqef0mHLC4q|LQF@R(g<+e5l4Vr%+fd zW36Qj-(#Q}jV5X_BvFgp`5H9Q|L5M}7;>9V#d>sBaGz)5GP+{N=s3S5=eSCX!fP62 z{iZLv0l)sC!7kQB*06q6(o%~tuH5fFNya&pd)U?JF*vD(;tuOv949-o-u0aO5ZNP` zV_la_B>xT6@%Q%DK&|8b_KEM?UW+XD(02H2glVY}wd>P8O`iP9Nh40%nxNXpI#dB2 zIjn6cV!2;EnjGUF^7!0e{?eR#*=yj}B3QU#{pP~btYVrk-B zDvS1;Wh;C8nzS$dUv}-YjU_UP`9JONDlpAcfsy>aTYv%%LG&{2uz)JnET2A>%E$K# ze7{CM($WG?EK6l@7T=c+xy;SXFk)@`XiYkF6c&i|RbX9n<^=_FZ{F1p-i!Ruw$vMy ztNY=_A|K=*WiGDK4?|CSqgJjDru{?j8=0%Om$>iooO_*IyS)0ytlKJn?D_P=>QWzU zYfjh07GFee_Q$_`pYd1y;MHd&8tDAcZHGVVlY3nF$Oq$k`eC%Y55~+G0jsXeaysLS z`074L-NZa6asWLlL}2r=2s~dDfqBCGfWino4Pw@9p9s8Uy`TkaQN`RBA2}xyKXb$J zBP$#uS4UvAdnB&%b#)u_@44@KJ(+w}qez$rkSpM8$B?ZuvbKF^757BwPa648Bv!jJ zuX-zea=*!KJzy4ZN4ghmBT(`$vx+9BVNF3QGOg2auRb$v3(`>AJ{{PS2D?sasNjPKk6+SY?2-n@_v``N z!9D47WFZ5{V0B~G!n0Hayi7yAKFrz8PD73MbUAKH1$L#;mz@Sv{anCsvg2C`tXDja; zhpp7~ZYFmYDrJVEg#;#$vzTuu@4C3iUC&msts}joRTQXN!hQQ0%nuu87T2K)Je#M$ z*ipPs>RZBGM}gI^%H*z1nG8uX%aSn)^xvewxe5xDRW-}Na%HmVCij$*707es`)vFp z#fDOu=0R?e_gwL5=2V|zwzP!>2IVQRbg5Zl+9;5tHjDm*1srQBkZ(~cH>#QC=O@-b z$R3)wPnYo94~Mt=VI=R9CqsPk;jAxCzGPi&sW+ODJ*nmG`#TZ5mIE_qVRUaIG zPY&cXxtSPW+;C!+dw*Z7jP*f-W_}nG#|-x_{s^c&0$&QrM1J(cQnep0{2=pK$sc|N zeo(gbqbJRmpSeHUwerRL>QQhda~QrS0y#?}aFEyexu+3mefqz9hWE(s2wWj2Tu%{+ zT8U&7?~ont%lyj>=1M?30_a%;yq?pH%P-3 z=Tz)ZNu$Fm4U<2R8{&QUAtMbnFQ$<<;-1=%R4gG2@__eT%ok?Hze+{(>Et9`n7ew9 zj#5=FbiAkLAIZfP?;PgN(Zv8n5;zt4K~Kb!9Gc{ODY5PiIO( z4$7tEpdGp5A8*^*;J~o%Z$El%3h5ea}Vupvpt^Cw^{s>*L>Ef3C_aH=VQF z#e)MI8q$ZnbDI%TC4z(kJ{Xy0Gfjsf+R7yBTUdJlB1Su2g@zK`Z@* zsJa(x|uGs z`5YOIwdFK&C6q2kzIJsJoh)dZD92AHN=;+344RW5wr7&$c4C~28l@2}Gp8?HrhC!j zh`4Z``HdM^-v=g$=2?QA8%dvqU6Q!ybmIJ0Cnfxyw>vtbM-_5~tifFNcHlZu2^mdx zk!$efmz8L5PuE461B@d$XRN1W|D+?1PIbcYt&Yg=VTV`M9r1ahBa$mC5qQ%P9y&*6 z=JD%1N4T*6WfotTbb>jSLse+O-kKj}O4tnM*PK6IZb%Bx^*x#~5 zi=pQ<7*LW3mj@b@+|^=cWi7LuHAow+MGohJU8ivG^}7ZYE@{zg8Z+2B>Yy#t;P6fj z^zK>&?Bo7ll9v4wbWELQHd}oy>IZ9Zsu^=NBl$CJO&GGlgbXjv-QF7EP-4VdfBF=c zaNW&)xJqOdOa7sA+m~F@4il>98*!^KSr^t(3@-G2%wc}?6eH3uw;8-@ewgP^KEOBZf-3#O%h7Ba2*4h%CZuw&uT}k(su@_^x zAI8Nni*hVoSEdM9?}&imJDs;4?3b7s3EQrbNKT+rb}_kYKC9lG=QGQV8ODL>m}^f? z?=*V|t}@$x5jnzVy#GJtV*Fr7I!c@*Ylp2YEq0K)+nAME%~_(`TA=kd3zV!P7iVjU zcM)_CJ}ZYw-O1|B^rgeyAJdkRnGf>EdB+jhG?l;KHWE$8(yiA%5>IWT@Sbz28#`h6e=1tasOhGs~86PqRzh~3=_m;WJ7U@{}B^N%Oa&U`$<@~mEIW6P- zryv(C#<|F-qhwEGoFp&1gJjxvl1V+CndxSU#(||W=QsVzF60`GW^wya4!KACFyfvM zc6s|DgY(t9x$MFDn$JU(A2)i_A15g4d0HD_q>^gc8$q|EFlMbnENC= zmXT!~E3eXXRmgnPOU&k+lOo|{+Ditrrr@fTPAih-zntJ92b>T_=4)^#W_CVOqOMAb zI-}Jvlfh`SR*mnKLQ#8SD6BPV42#fWMJ*lHFVN!hEFIR=)S*^o9q#1O`5HjJ;Dr%0 z$fK=4!hQX_%n(jdxPJ>*xa;X3>_aZ326?%ToXyfoH%&6@ z7b-k_>`2Fe5>uL}uzfS@1s}*h)aBa!lp2HL$(55)i8`Rhtz7#5)@bPpNR_hXEzk?i>y;* zfEDv7|4JY)tdaf=Q^auz$G(3ZvGO~|n0n-8PAf5@K!sZEoLCYm=Q{$^G%#>{Ngl0(<0LHx@pIEJ(PGyC@*fo+ zW4_XaiG|E!xI=d4AlLbed2YzdOjxRLzhG_Q-gT9QdzVcL_bbN}$aHJv(dZN@?Uf|| z9z7~klt(4jTZ!mMCF|qN@aX6acsC6dpSyU^7X1#-f|A1j#uH9S%sn{O59kW!WVze9h4lCHwB~o zEj40av-e;d86KXWBjk0?r_)=h*21$;i}k#YcJS*7tsmnkxuyVmwk&R#(2xAgq(kJK zZqm^fpl~lB57PBIxf${*Co5RESG=K=%d^`{xd5efDppF{3T@=XPX`&SvqVTMORlrc zGA>DhJuelw%jfjr^}gt>;Qc<2TsPMyZ+`kCl+Wkz3-s${b3L5PwRNK?JlY?D`@G)+ zL+G!&mX1X)(lBrb`;DyA5&t6{3*Y79_PIPPo|uOyt`VRAlZzwTJe;$1l&xVZSu@s2 zM)hkgo|8Ju3%#>ghyrIV%K=9%;5CFE#JL<>c}(Av{ZOGi-SsU;Ai1eOet%4GN zpTbdr>x{nkkvM*znF%$b=%=M~Z!Q_MLus&%Psd_DtF7Cl?*FSS;rYewsTyWY%R4wyMFZfH!Oz<97B3l zr7tqij~ps9r@4-LINcvlesMk3m$}zXqR=Fo>l#b0aS9`m$FVh`=_Tyu81ZglI?BqW z=i>bFJlr3Zi!M|0(EKv_!7{G%r`wCg zIY)VVuDuv$x=7<~9b`*=XX#vAD%1N|AXY{0GtLqlZd>AHEZ5K6k2hZML+xFDST}@T zL@oRA-uc0X^_r3|5!hWV5*1j>apt%>#gpqqj$Kx3(=oYYI@}%U`V38HLlt{Fo9AKJ zX!<<)xizATdGBKO3*5@XntBe>+t^;xySA4d&K+cauXbW8>nQhPEzqw^IeNa#Qgx0c zb{(_C%_0l*sKL*QYu{Nj{P5Dn54*?vVS6Ea1rA4|71ylmGFa5MsQS1|n#F<6u zcoUP3;~{C-Gc6s<+H$VJYwG19o)LJIW^V|Ba@#({+;vm(H?wWuTwMkk2TeN zvS?)SS0C5Gw+ZiiUoA4%nb=?W7#k*=;QEq#i6_{*Gv0)q298^GE!=mhEZpBPUtWsM zn6}u$-TA3jel1UuAsk1iStrTo@5wUtXOhf+r$Y7xCAObbB6m6cjEkJ$xK7DDpHMu# z5rP~YS^NO@&+~abp3lc)7q#dXNY63HjV>WN%$`l2`Wt)T?-=oUjtN()nXvH(>$$_p z5Ay3VtI1ZLQ@HmhtGAV2y~rKp^XWf+#{HMa4YZ=E#pBXw#jR(OESZ!dtG_$qZJ-io zE4Rh6I2GAmC#;yn@sxG&({0qKd`u0?Cu%5LgyQ@qHTJe8Q#q02Y3(G`nxn;rC@n%m znL!<7!org#6z?&i{V?{gCmNA>pMCD+^Gwz zZbzVx679&rKHQ{2aw8R%_^MESM+mN_ao=NXDBhIPUrAoq$}$x9-)XUrWBj^}TnqNo zVtO+j+!tvvD&jHsVwn$ql%JI&-NMJ%gZ6>7e;;})ds(>u;e4ZL68jeJDcpCgu=u}z z#`&uo%A{$3cZbnVss1PyXRJQD}gQ+}VdK4JCYD zf$Z(#1&`%nIN6_my=vqKCpD7o(SKynXm4~Z4I}%Rim3_Y96jpFwuVLGJ;)QHVm>dq zHdp&>WL2y$6}1I2euNk1k|$byo*dSPY+PcmcU;pyQt7rg=H3fKMN8(r*3QQ5Z}nx$ zi+nM3^F&4${@z~f2Tsez*^~xS$edYKh$me+JF#Lib6Ux1Zf#UYlw%7-G0qb)Kgdh+ z_#4j8#(;N?WZuC-u{gxs>d9f)&f}@@CJWP?>r3lP1yXQ&I9$tzb4^N4%|9F2#f`=9 zYrcGCUh}b!;pjWkz?5yqE*q9V_*6sL%e?P|)}EMOi}lF<%nk3EgH=ncq;7n%M7?E=m3-Ny zs8n(RIoQFR;w6!P#NR|uU*B;2wob*yjX6kP)kr?l8~D)L2SxqEuyY-Ke>ThkpVdlK zx>C8?kQr6vn|e1&MU^($P`+#|8xI!9UuV3KS3*9~U_jL0S(tOFfy^f-c)1sIlOvg< zy}$sQn_1ZV!%8BG@?~g8Z?xh0{I$b?){nDr&7+ZYK2{{T{@#f8A=mlAfXd_(N7ij4 zo#RVI*V_x%FYtKgvd_988`G@Xh~t$asn7i43YEiA%ZfbU66P<>pcijgiNpjCN9Xu( zEVM|azdjpvuGW&0cEvJ;dnzlK8=l^XzRR2}WGLE5rH8*{5zj+~Tj8v?7?6~mjd1RU z9uF^+q;PNi;}(WnuJkJM_)BIrm77`la(uTZtP>-K{wb+m=9|3`Fh2|teN$0H{&Zrw zx)QmvK$`UBeXXS5&?6OJmE>M8)|NfP^X2>iZ{+j}M{~0QI)4AjH2M~Y|B}J4J#p%D z7<@h(aNHvs|MqMkhsV(q>Pb#El-HXo6&dZakwvLkgkx^D=F*B9o1PbIHzMqZcc}?Y%;~yFG-V*`M!|<#w{hr6NVV+!Dreqe&&80rr z5*3c(r3OT_&VtLk`f~YEf!ML{vUX4I2^Q($!28bSNzCd=B_reLDpF_P2I5a*R zW1Ordv-}@9GtGzjN#R&pV8EN=Y#e@QBgP+PQuQ zNv@JS_`_8A?axM!6;@L7^=~nE^gUl3pZ6r-ukrNUEi1$P*3lBz)&WI5f>30g$ee-E+@<(@u z(;qkJu-x5khr0uUaB5m2j%qSk!zqK?%xL*F*A_O*gHW$l0=l(fKF(M2J5}Q44!wBo z5&{v~AOY{cXJGsIGPvA5B#+zLVV*h&iXqGeCKpz+kNLdxl$9~pI3b34!JhOpE@m(I zrZPO(wO=}ur^})T?L@6a){8UgQZl30@@Vnw$Nc3rL2xDyHGtgKKc`F4z$sqrHrZnK zmHi&xo!_{{S;WlAPmTbPmAh#tc_wy0&ILu#xBcVA@SI{C_xD-X)G&UVO) z3&Jt-P`yTyUvo6$?b=wmk!OpByw)nudoZVGP|B zJU=OXeVw2T+?!{H`JcnmhU@Co{j<;L8hgdE`B#Z;`jXT85VcW8@RPhp)Z`Aael!zsiwSX>UgM;sa7R!~tcF zfrwM`ym=bo>{^B;nge1>f8yk0!Dx3h5$`Oy_wl(5KbS*pqOY)ue;{tPVa?B!ff3{! z+j9-({SvQT(z4r&?PEA|gLfvMzV&vlCx2P@_^PYK4H zd5L&=H3LU@{S@7c7Vo;`J-IfW+?$@kn;95$y$l{Z;>6m<9yjToT*mX0xskji`McX^ zqh&as8^b0B(w?j#3bV)h8WGaQjJdnx zBxtN14)o@AHHO|&zYMHzYsS>{Xla^ahoF5SSUWTk>qcgxOF$VO-ij8{*`xUhX4sIY zsvnqvCw^tHR>nw`2LCVrZq4)H6+*x2cRq*5#z=#Q_E>u}5H-Ct$X-VuZdY=ttKwzX zO$SU|AB0yY60zxW1}@n%-)CW*++R*_%Yy(kcG95H(Mk{g3tOtKInsuJ20!w;$%BP$=T}UTJZ(jtKwwzkmL}U;lr< z|KHF2=LYdf7<}RJh7A4C28nu?fM@!u%^SF`UeZ7xdGxnFEp&MrZ*~QJncJy$_a5enB^142+U5ftpkgFG4e;#l# z$+3-FSu;Dg&8D!6A7-`FpV;}kN9yo1J#Ob;yEsQ>cd>`NjsEcFCHfmD*6Kf8@YO%P zfB9nVR~l*Fjqb!n8oACrWz`>zRAbgg--jZ`t>_KT&#I&`KyX6#n|5 zk)QsFVz6VsdM=$icN63(^PHLtraxyJ_b&P}Ln%im6{8cRULBom|E!atAGK1rOhYFM z*U}Ej@@89{Y-HYGyMgSXyv23CE!Lma8zDHTuM5N-Sq@zh?_2_CK|Q(-8-FZB$~9H?yZ|(BIhGk#1cj)E1#AdeXdsAjI08UZ)CAI&=U zoNjb0@@FHs|9!P$_o^|=TCo~)e$(-DCIkanlRw^q z8A@--LE5O%pf|IVxIfTvjRuL$wVY#f&mfZf&K+2zchkb3?DJpi=*?mMKJ+)Ur?}^w zpU6KS&|q~k^D~^ZDEP_zr{`Lv?&7`!T{?^3()s8|HnFZ2+f8H^`|9xiTO!6S=4&jq zn6q1h<=$F!jHBb=o(B2c*G`CM_62`F-eiRTaU<$=V!h{!5jDmeG1c=iirtO49B)J+ z>vcJ`+2_mWa?S=LwCuAzmcgD2*6d$QVf~{5dz6cf2x1*=2VZ}oG!svQjj%WH>xcCD zOy&M`O?ofFS>tywq3Lnf_?yzllf@d~HzTs!nK1vf34NC_0xSMD%iO^V)bCg<2W`vb zf!YFnR0>S)XO_(`6u9hffm@wf<{--{zxm~dtKw&x~(5pobW;Y{(jhchTg`l^g|BxB`e{J zZcCY|`-;3&7&E7jFrW5V6mHy)z%w1!`!10PxJRerzu_pyn)E{Mv$V*Gz>5g-R^+M1 zkss)Pii}m=DEO2ozqlY0lm3asqAkpouEqUW{@wi-5$L)(0&^QO-_VV2IX~uACq*Ee z`^B~fW(-#1*O3uez`9to8j2h9s1uErLhMq4UfrPE#}_ywwnC@`!pQ9%l@&^tbO%P!-A1% zSZ7W{gVAZo=u1v=3*Xm7zJMI$HnNUOwx%P1zi-4q*8Q7sKVnHbx(?38qyxFASwENg z>U74<$VCY2bQ_~`(RDAgr!#Z$;Rk(iabzRf=AzbD=1DckMN9VNE-21HR=+&#&ZAq1 z%;VTS^fCJ80x@|QSIX?$TDfREA`gR8n4xP&&ha~cS3EN(9P*H~joA%8%r)$g$MeqI z-SfF9&d!Bv7p2^Ebdc=lEoGG2Q9gS)%GtWD<@!rUY59*zdNgp5WG{Q^H_=|k|7$B# zD>#W?D`zFa95_v%uSS(~;B+=;iu_KBrZeqWg+ zy)Tn%+x+oQtRFtuli|%|E|-lzCLZ@CALWY*9zJ+;gr1bMe%R#8%=UG@$T~=0<0L;6 z@g8c%`=x4aAFMpZER;ijXwlgh5vhK>2mF`|;g2<7p663vRC1y>^{p>64|pH-^+6Y% zKl5bych#6Zy2l3}+WW)G&ktq1KevQMqO=Y3Bgq^F^e1P-n!yVl8RDw+SX3t4Q7IBF z^TJ`%i4LZB5%^g}?@n;>^G|4t+#W^vD~1@p~1&>yuh0%o!fhko(CdcA6=6@nkJtzX&2jQ5&pQ&K9R;m@U^TN7rw2c;sqe;TI#NX6lw^gd2bC##T-4fp6z(J&XD_ng@- z9i_)oVNPaGDetisM{{v3qFgW4anO+`Hp@ zC9mQ=7o3Y(3vzMkI{7Bva|x^RFuUi?i`80p(I2Wt48}EGU#C}?zVhrkh7Z%1UT9w| zJ@#f*GF+`TuE&*uUT$lKbTq846n(K{(UKl*QY#v2sM_d172k9_KBv?zvD#hz%2hk{ zTd&`|FsC58hi}gI9*^@P^n-Wr(|5SH|6*motcxx;OWdYTd*b%COsW6U@7jflE$bQ@ zc~moWm!WRWn{U=HZ=*Eas+uCYjq$R=I#E7lB+Ay=NpfROl9V?j%E_5pIrp93#q7S{Uzlzu!vn5$R_18%1NS!>Ws1tW)ZcYkI zkaQod)NQPhG1chk-mZ}YNeObtm-!FOrgoe_M$)8_c=pR|7^jiA2i%(?UlBT7g)(2I8%x4Ax^O3_mfQy99tcc`I`(R=afrR z9WgLdiGTl6qCqmf-Xm0a|CCv6-=f8?W&}U-^E^tmbo=%b>E}?klqQ=O(tXXir*Y6}f zQqJTZZiZm!cQsUgYWNJK3u6znr^D3f>q}1YF8}*26w`Wg&iI)eBVFD02Sedef%Czx zOoi57p6L#(1DZ!(>pFYa%eIJc|Bz0QO;TJ~bo<(5{ zLVCRC`n9$eO>{c!K1*MSk^cQ>iI`u=_1^^zCUDMp@wyhLJhe!_ZA3BmN9zO_aksY# z6W-CMm`w(edvSfw8u9uF-Q07H%p{<9n``}`d?O0#8gb8-Zbj~6Rv5)SRpzSQ-e$xb zGLU1Nk@q-igxQ6Ack_%`xP5p;kU(P#IIF}4G z;WWSgKYm8{*7PL3c9HsvouwIhhcVmROHcN|#ND!hnbg~XL{oq>UhZ}Fm>G8Q<#`(`b3nGv} zUd4YVdA(R>h2A9>H#Qvy$T{G7Iz3y=q$FQ3HkR{?{mfBrz#K^DFF2FVylMKaaI3W> zcC?cWR|m1QR7&+DO6kmVF|%GdbXaH!H%&Q=sHH$pIwSqg^LKN8XFu7W`{DjLm*b1Q zP5fZ}jBI=k^S2G*XvHz6wqqp5{fWd9KD!Inr^99(`#N5yq3(%GIP-$M0p~Tgc6sQO zl#4G7zu>$DeOLW*(YLcomRWX`bNco&(z>(!ZqQD;RPP{T_R`&S#uC>TlR3StfO}jy z1o1P>twTrT79Nk8{WcBB`_oT0vYRia4~c@q=_sVmqI;0@#)(Drf>$SVsZGWC8R@8z zNIyUV8H}#!h^$S_?oZ&^LW&M;jUMjzuwT-yvY)nM+exD5op=aA4B*0VMh*~WDR`rZ5ugDj;DJoMWJam z@`InrdKQp9-4KZb>GYu$@-zF9MmIn6UWcb6#qtt1JCm0WCvQrZR9?R?sGg9E-%Gz> z$8Z-}-?_cqOJ^pyvz^?o(?N`XJ2P9vl6eM}SU$;;S@LG-!hVmv{VieIIs)+r$%BBs zN}S)%cK_@?dlkSx!;7H}z7u59&nM-W`SeH0CKE*p?u(=oNlgQ7fOb z5+#!3RWEw3;wz{yV6qb~vo^5HN`;gqtPkWnVo4!6#&K%29M3)dL*(OTsu4IM6odGD zTuh5Hn; zjlnxvbBbj@u0BO(wMvrX*7P^MV=re?vaJ4*B6rE9?8{f7z?E#}da@xul(0-tp~tmQ z1XNqi-exsw^-?3-i5|kfJe~ns_=RZ^ypJB1&(eff$l=);F$T<}7yeuL|=$}j9-@Rl>8qUm6W^L4TN|wV5lO$o*QAy~c!oufH zz#1pa?L*FiUq}8@VR5n=?W=^MOQTTkgR;gkS&cM~YvVaa+z8fU>mLoyd}YQe8H@@? zS)fA%yEAUOz|KKfvSJ zJU|D#D>_W>qr=B(bfxVlPqdVLW8cT{wlksZ0~z@fk2&T)M&k0v$oubH)U$A(N*3hZ zS>~F?lOsG##__98{<(Hsnv>i4;jEK{{3O{KeUx4!6+Ro-2kWQAiO-ya3{oM;h3BVJ zD6Uo}2TKNapHYpC9K)-8QDXx?r-*g*Gv<;{xvF7ZihQhv4l8**dy5f|>zVMI+^64r zo~H>$_TMnSv`pdN;+MkxQxyyMtGg`RT~?D3ncyT%3!4eU)}_+;4iY@Mvjp(Zm&PdY z*=UJI6%^?3tW-uHDV4Dv7RY-t0w=Gs*KoN%x;OS`pAy}!<-v_IMvY) zK{I@Ct0H-7-zc==aqL`ArZJyAQ%mR|w2DG#ch2?uUBasfK6i$(@2O8ZOgrgnyv6nI zw;c37L3dFQ$JG_&<@D^~JEr8^l3wB7oh0>uQofJq$c#@H=}V@2{W1#->&!8Ax+PX^ zwtzmx0*74uaqJU&%A%Ob&9T1!NFLMX|HgdsajzobcR2#~C&Teq>quyH`3 zz1@j))uyDQ!tQjmT9JlXGuaPyJ{P{H^Du(z24}9_$Gy+PfjRAD`J>LVqI`RCWgV(! zlMYhphLe0Nv_Qnja`-TqPUvcUR=Zf@%u);7IOm7nb^Q>W?~8X&*b5rxi-{}zvFhJQ z^!-EMJ;(R&!z1BoABk#Nk>muJ!~HfD?{w)n6L$%RGwIiKWB#-Ue|J~*EZC5*teb}~ zTj-kqn1}DDT;zhUgM8ZHA`$28<=^{ubP=_c=-!s78exflmX?W*Ec~{oJXcqlLA}@) zJumZ|Oz^{e_Nnff$2II7e<(TMaA+Qd@|ICJaUlu^J~HcqYr};{(x4{;>z$pBa{PC| z>vVi&KKR9NdAMCE4>P;vL3JY!A2_BSXp)DcUtHzq)vnS;<08Z8%)ZvQGkYJM+lO;+ASu)$o5+j30U|RuFQKIuXC)gy@gGdg|rJfRlwyW6t9SR#h4+kZL;)|Xh zyNl%Y`26{LNrTGQIA+zqb2BuyBue zv~V94p>Y41NskSmg)=#pNqUM@+Mc)M`XaV6tSqRlj-M`c>h%e+g3`{2YUlj zxi)&G#Pss3ak5m6!)?hjZe_1P5_{vftMNDI{#I+~U2mhqRX5gm?X|4oks-Wd#FVin zJgfH@Kc~{|TjL46j&uz3S=gQXBposo?iN$Y;X7HluXVO?-|{O-#@y1#PWPi?`6*dW zFVadzL!De_esS{@XZ+?f@Zn-54qjGbt%ag9=*>z&2_^=fg9pTR!* zv0A(vuEp$R_SoyRII@g2=XNHv8E3+-2JA;75-rt;5>;T8v+>!$xZzre7t`$nky>*Dbn0BaU1D=Za_FMD53T z_TEVEmBPJcbNU7wS-8huRk+_G1K*^Zg}dfOqQu-wktKiVVV;*LzdP#0snsz_AL4|0 zwN=O)r^3WLTtn7%M$UC5a(<|hurw6y--lq5Qz&Z^YRnz|-+E7ndQ(}a=Q*l%TML)@ z{OpG7aK=d1bJSzh=X&UY?-P{DW1O$Waf8P(*3-hh&vH6F*{{%z=P7QE!aZy0F>&xu zk<;apWdPmF$L6y~@LRI@XjK^ZTZMN+x!xVCL~)W66gO0uo2F*}SSVcUgrdgnP>idl z#-tdIu>tH~`^hyQ+1xezxDP=`WA`8}`p1~?Ws(V-uCYJO?lEexcE5YbW4Qiz{nWN_ zKS{>&1dnGmujer4h5w&**uN>w<*!2pVn1g%>zVYRsZ(*g7P+nI)^e*6xg-~IRUgBk z%cQ4F$=+-4`qHn?PpK9@4DAPm zd?T4Twpa=p3`hFRaEu>mz|Ak&khM)EyB>Xu#q8y8!9KV(sVEF#9<&8>u|E}xCfyq~ zJekMZj`<_+v(fFol?-L>^Y40IsB<$6eFDh4k&E2%t(8Q5FOp-EhGXB>Fr?KZcbS)s zO@B9%6NW-5EE&{0ue66zF6;A*~qdvaS-QpsIs!+AhcQ4KDZkG3LDx9pyvAQ*r_dW8Z>yF{f5ZH;pV+J(pNk3-gCi0=QNZj9& zr)$T3huQ`#=I7FJWPKTOyF^Ztdwtm?9G|`#kn<%AwZ>UXOXeEe4Ddw?`OWb!4RGLj zuIy+pwcF>*+bB=;aSlUulK~msv$67IBk^Fq?a6YU=szS369=Xtyh;uQ#&6jX zOE2E)aEv9lHDFjauJ36fxKt=V?Yz*F*I{FRj+1yi>z7%}(>mn5%*-QZj`K@va%Y># zk#%S!!SsYy>gWSK_e#p`(_?o`7Ai2W*=}=@Pu^6fC@2c;stCHdBE4P{G4p|r>z zj(~nU(YSmnt{HRCrL2yOr_Z!isTU?6*@>G!=;d6`T;MM)rCDaaT=Aec^AWv`7Y*>g zn+^XhO{MTcf!z7m3l4GNa6V^XO*$KEbDPLpk9@h^$_KB1@;vI(zHVqLt+o}5U5qEH@i@;1rlNf><`kc6EKQsWrTtAW)MXuIN^@rM z(900psG&6ZQ!J68p0Hs3`1YbySj5w_nb%M{IhILsS08-i^*ri3pAQenOXf6|dyjsL zRdf1DJ;E_S=#Jo=%)!@Mg4X?!ZN0qU{grv>O7g|mvXR@xUV2y;$i1@R^jU}DuuUp% zYP0BbZY(XY7s=UnURbK-=e0?Xi7&ITfjPy&UH-_HRi0?_kk@mn0j1yuN(c02eT15sg^Wz zD3*X*p7=3<-hyogWX;Y(Zo4|tdRl>eF7igylW-g)|9jIt8`>|{GGNXhdA`dV19|^8 zqu26q3v!e_n~1mSk1U)%9K*B2V0>?Y_t9+ZbZsbw?+e5+dKl`A3WHTdDmwS0XLCg} znYyb`O7_#+=*|6t3e4$#n~h(c8cS-OBI&f4|6gTc7+O0O{#Ja>RI4YJ)`gPt$`_~J zhojyTa)RUmcXF?^#JflujPpX}Zea-JUfF2B98_|wFRyZoWCMBdasfNxFd-E+{>s7P zO7&z_UV-fQ9*%9~Pmid{P4}UHb6`F3qZe}bm|@t*>-Kdm-tXjRtDLPbb67Zk_s0v? z?{{KYq5;9_*%^99z!)1da=JW?0M34f)c6&rjzW^k!byW0_Aj z;zqU-OOFCM|IG^r$%79GVGdN=9Ncz}m5$_M+$>kYbR`jyu9=A6Xhw^_4@$*$wj3wv zFQdoseF5v6HOMFSjFIX49PnaW5Z2byVBR14-QJa9$If`k^RQ(WkQ%>|>1V7-Z`xyW zOo{YuwYJCjhe7D!L&wll@@4jB{Cs{;f^+N<8OyAny$J~B_ZJT#2iGlLzE0-x&luR^zMP6yhAxS!KkIqJV1}`UKa%cvir9Uw(M!LclA0-4P8}c>p z>19hZ<3jy-xzD`jYR>|>eoDkwzW>DUX1vLdmjm-{@&Ax^7G6>3Vf&uJT6gUh!6pYp z6kGJU$68w&ySqE6!R`VE1C|6sF>@LDw3qWw@_Tlo{ki4z~?M;EN=r^7TvqErVX-rJ0{2Dl!MTl zV`bVKdu&-vF3&)(nU-s~MhbOOw|!Fols!iKEkom9^d$DnLD+9{m;C##Bo8>c6M3i@ z9loB*M&8{rRM5mqt()ZalIXdsOg_Rc8wpm->28uBzkk_dxmO6LO{aftZ#MSUSE&2G zKPUy(_ITAf2=z0QpeAqVS6!hVKwshY(e^M8T!vHR>Ds+zAAeVR-y##`T$UX&9xub+ zV|0jFpN%(8WoXtpUebN+G3$OXd3YVF9VO5BnEuW7^ccQyU|lPWxet28yvc^um@+I$ z+AoJzIbjF6lJgt%n6f+@k;*bewoZ`igPc%ZyA1vEnX9{!{zqP)=Jn&G^xu}a!@Tcy z8<;D-IR|pI4DPk!Oz9L%_Fsp7OR|v^WkJmBJ(5<~0&i=DVEb#<0qk?Qr}~Y$ z^jGfc?|`sqa-d6eaM+py|I=mI`XoV~k+?i1g~4@5qvraCu&>Zu{lu&`8c4#j$oX=O}}9a=8Q&@ zGyNGWarO>~KgQ36_d}~2&Hp>UXX*Kf6{BY zV84{su*ces!I*tI2{St6U}ih!iPw&kzNPl?_6b4lx6Gs0-$l8RkL|N{=M3|BgcmvX~s`G4gt2PBRDDHV2pa`Sx*5kiKxhGiHr#`Kg25@*J#P$1}vE z2@<-_30KAkV_9>4AIE3o_Db@Yar7sSvBv`I5KIZwVcRb9cS#)gw#G>e`QN<$p*XgW z_gi23WXI6&nZf*S^004rg&?+wyrc&`mE`Y!(T|zG$euYr^laYJF$;_wcSae;rYA^g zO()!*K#rR}%AMKt&-z*Lcvyn8IOKqy{{$nl4*Afh*|?$M_px8RyxD7q;UPnF~+v=Pu?)PZ|@9+I;?KO*R_yI$S)qU#3LRBY7$WHA{J)JR%3}P=?$gd!l7~`Tb&T73c;U6N%-xa%B+cdp&Hf`N9&!jn$?%cXd z#xQ0lN;i2fs#7&R$W(B;MeRR4O_gV)CGUy! z)W+UVoAfO(J@cPGGrUjVKU1!Ut*1Qhnbvbby^NCMjnkJlYLhW3r9;L)4%IUj{%Fw6 zII%%S3)#?hSHCOijoBSf{O{_n*r8ToSQkF`l{0pCVzzWY7mVwv!kHwxcDk~*{lXd5J2}xY?t%fAnEx=H zeB=s8yoz>4hq25tEOy4p&0+X(nzsS%E->O4Q0qrvOj8bqcsTe>-YK1((DJ~bT6gEZ*7 zITU)<#*fTo4X2?7k9+eh{&E;Sw9KB^5sF(n4fI1a%sFHJL~YipYa5~IM*s0+J+85~ z9J7!4e(c*E&d2@wu?LsuRSowu7kU}_#kB^!U&RcKd3wy@xzU`PdQ5mj2H2VX059l( z{)_#(>`C1)lQoDz?2&E9dQG^V{Ffg4HX6~1^I)=x=k9d)yy5E~=6O$bvchWy^S!WU zvj1uxE|#Y&qaO31hv#C`G&A(9Rkw9ElgFb==QSC}?L6m5w(OMn@t z{-%R*Yc2{)bFsd&8I9iNB8UHds)!DUES?{o$icQu=1MDa;jg3Dhwh#1Xu60`neljH zE;ie+R{k$tKWACX;+nA$&-o8sY9;gTxJq(&l^odQCTV@i9eTUVOIKI1@8v8vqEu4p zva57>-bR$Qon=UpqclrzCij{;N+tG%H+|tQ*=ro6`m+|&a47Q|_?$k>kshyaB^?#6 zlEkb#yDrV-gV9dXA300A(QXnq-bG#qIf-wsi!8LXkc*32Nl5dSa{e~YU~4Mq-?K=w zNCiH_y#&f=Kn(U8DPw69YBA=M!gB&HDioX7+w$Tr*9{EB& zCIE5s{V^tRhpJPqFR)m;`x>#3jOQybq0_%aMYsGQ!-c8wNQT4qH$YhTR)CO*TYdzZf6a7 zJUvFuv(RHVxkc99qxaJ_;AVpTdh%4Gv*5>C#Vw6 z9N&_OH8;p7`t!f5)2p-4ghMTv^SG28SCR=&K4jw0H<>8&&&1~<`WV-;Hqtr^4>cyl z@^vqgeenC03F~hrOgdDEORbCGF{2RUbLiw*Uxf6Yto0`sVakC*6nPXP=QjV%x_|tp zLX25jg#GJ^@Ng`%5xAgR6Mc?5S)Yz8#P^eY&QE%zYSKwJ$xf8Rn@gR8Z6uHx(bK*;O58nn zxgXL>(p9ZwL{%3#Q>~>0@O!ZMLo3;HjIN-Q&1F05CW8k#iBo@Ok>#`zYezaEKDCl< z9~(=ZSe4{FQpudYtz-zZ;aAVJ<@e4(c4axs0l3PAJMPk=eKS!STS;DugY-M(C|9Q2 zlY_UDj#12RXO`j`I|VAQP~sSCRJRW+(9>IqRc;C_^(m8m-T3_)O&{uKdK?E?WboTE zxs|L$n+FO+t)ye>x)MpR6i9AZCMz5M7Arsc8^0@f#!1K0ae7eam5C#n<8>o`%UWyZ zrZp&&F$W|Jd$OK>V z#hX2>*|_>+&s$&ok?VsM<9w0Pi1jySxsR>jM^45Mmc_m}3qOtp{-|@&A78d>nI#kj zZKxKV&yd$8@4NMnDEvXrrB5d`gCyUZ{p9zm_+2cKheB&B^4=-dO?3M{V zv+3h_$uqMRtjk*QyLa7$>oIhb71QT9&jg2B?@?BPd2o^BRMr;YXc03l?vd*?7vd4W zI}%Coy$j7jr zd4v8eGQ}VI(67oftlF%ZZSW=+(}Nr`pS$Q{0sd%Gh(p^75i-3HA4%`kuTT2NX`MXXZj4F~Ze0G% zy{I4QKY!FuKT+4@`S#QPv~#)LGul*-Pv1PxJ-x>VH$MH+ntB;M zG*8lWWo2nIVs>^7ja}tgf1^3ASzza`4Hu-R%?a3>t{zlBGsGV170V~TF+Ez(aRt~)f2_(GW%V28s+rMWQm=g zBIUm8MeUa?hl1m!+p9#`O#r545TMeA2(4noS zi|IPoiaG34IYl>9P#A(;>F>5^P>JU~^@BAS$j8+WSkv>+;CzY(5xyF18_ilD|J(y( z7^ZpC?|p;$lze=%V;J;v=mb}3FeRLSW{C#a#x*DFU9(yD>c!rd^mn0%;kwb7WI)5= z20Flva37<`KfPHSByUriLMG9}02AGbed7(N%XQ=uHS3udm|<4Mh((jgov?oQZoQuF zSOXU4F`t?YQ7@j+=@%RD(8_=MJ8`oz_M0})pi!C`qK)l3)q`+%NJ#L>9(Fb6fPM7SVa~?*FlSRN28FoCmP#V zkR4||{VaKhU2@!76Ta}*Rrf3;#L$fx%Q5!PBFvpx zglUWE{flJ&)#pNlbA0R9+Ere5RY_D!dr?_bvhIZJnft};_OuuL{C zw1N+v$9w-CiqMbb>^BC$Ei?e-y!3k4hH)@FXMixd20EGNVghi1M?^h&vadae|BZ&1x;}t=;7012;); z>n0uQxJ#iZ(f*P}EFTqUmi}8}+!dI5murD^=7v`CL*Z4fXUXrhS;L-yL%t}C=5@&@ z-(VMwYc;ee?x@ACN96E3(D(H<3;nl{ci3!V-b5B!k}3T9qW}%Ja-7eggUrPDMg}8) zbrGs`bd$#RZRIa5*EJ>XQX#XAB(H5HFZi>2%~8PXDZQTKmDuB44pyQ-!>i0z?dFdr zpM0^kM<8o@WQmG>QBo}mmAS?p+mAWZoL}$y&=(o0MXfj!{JH+y*UE$r%gN#wWHBd_ z@25u*Z1ak+@J%6hkWX33dCO)mdrr!Ckg43aL>y@+3a{2OYEf&M)!aemS*$Sni4_hH zw1~@0CB{s&;vCF=s0qH9Rx1!oSNY@Us6f;?$lfBZ<7--xeWhn+<)7?*$kXE84J|&l zB5OJN97c_#ugy6NOJU;mrE_aH=TvuoJ{QTs+83egcdk?S7om}*05932sN86j4rlbz zps7*rc^Re62!rIl;g~#$+{Ivy-wrPLyMrqhZ*oO$C%O;!YG7VTR_~eyH*PTtVO%(J zZs@V%8Chzrk$E`G>YQwV`#1yax{!yfWk%8ix?hj5&yB9VmF4p=;{{p0L^6#j^fGD` z>h%klUEEZuzW1*|emqW=f5_EeT$ds#j}0>Syiw+>UGX<-`cI=&aIkU0^uexhGxI#* zY&c%;ryt2c7vfd&abDr@-WHDI)&{&i$~**Lx^GX=Jy@3<#%nSdwR0h@@({fwmuu`? zytrwGe-htgyh6Q^4B>I|db5@&)Tvv@V-(O+6p<|1t8`MxZ0Erhlck7#1HFf*h+{=p zsLAJtG*e+J*}-`RC!~>W{84#12F+z|aeXo%tHO}%%Ih;qgVr3ozgZjcme*zZSOcmp zW_IymBX-5HXE2%L;cPPwH0FMMEnTyuSU0eC7T;{28K9e@j)U z*O46@{ga;+^PUHh3>jW+LI%!Zj|cLDr_W6v}>LUaaOHx*qgnn z*3K|i)nLJ=FgW}syVEKh3pt1O{>J{$FU-ZPWWc$<$)WyZz@=M8^vE5KdQH7^a45FjgH7!&428CuwkUHnYLI^7HaA zqVYS6Cx^eCb0g=;0INJW%*@5$2h1?-qfi&}J&Yc&RD1PNs=qEG z+xWsklJ2=k*)tEh@PYfMbI!7NLMyqsNrBBvEwX5*57W8+bYpiLw@j_ANEZ1$9|qCWR%fWOBVi0RWgjxT6`X=g}l?EgyT`HP795T z3CB2JG;pmw#x1V4uz2XLX6x8e z4kq(i%=h&#-GkQ@SWV7+)KLXij{YSclgPgp(Gz*p2g&p=zpUhs=6iUy!S{ANBMP3} zBVFbBgKxMNy~;;pPHr^b-!|diMY4<|xz}jH-o*&=@8#*wy-wz1P$7DBDuUh4LUjIG zh#OVt^YwO;xB0E)LLZ(xy>OD4*>3Wl4$FU|c_wt8`^(DZFmSdK+8YYo%2S{R=ZHz( z{?Kauaqhb>>L8vAJUxy^g0J@Q-w|QRjR}Al?ZdnNF$8(T(?2WW4!tq4rV3UI#bEgPS;T;H zW6sDC`XaeE4LuNzFM2IrHPXUoC42RF&qU0~f&;J3kv>_7=UL7*NA4$wa6a$L^$xjw zciZ={_GiXLGp;)d^wM~cUb+rTmb|!R`9*hpHob_idA95^!3oO0nB&9m`H}UmxW=>N zmy0#XGlXLS$7i?E%;;4v$0^oWU+mGN{Cv(6K}PgDX22)1gkvJ<`#Wj=AEt577c=Hv zx6SQh6Br1F|?4W+uy? zb}qPAM}>A87qnl^^KM7-gPcFwP6(${T!T6nG}wMfgNYo2diLU3Gv|qedF1c8-fvJq zzxrGw3fj^!%=6gme&ngAu!o4_P6zgeFYA_v;#&&!xMYQTWqqaEhg|+hqe8ubu11@7 z$@0B{PPXZjW)a3v&?hapXG*!jp-d6<%B*}R4`v;A6Y7Wx-XeY6v(|z2;IvE z*pqcugXI&$nbBfI%Zqfov&KH&$%wtqMue6#qQNaCFqb**FM;5i;fFExmB9fOQzJwx})AeCCDN~aLcV>eaU{*)O{+%tyd zIb*q-6D~hyFWmVsCUVZ`Vnppk?u)pW z7`4TW)qTwPS<#FuOY?BJh-cXc73wQ=FSq-uP-l?E|G^%Cf5?08;J&!7q{^EEsWSDr zLF#`uicxKpL@PID1*;HRk8`^}dj+n#;M59dxPGFqz#N8sye>bggroI5UaJ5)`@7RG zFp{5FeKPs83~0mmc8q&Cs}M6n+2=LcHxHYV+0$=x4H+ z)H~>n9MG74>Y7L7-ySJ4gKp{<_YAVEhd~^UvX^9|3QM@pjph4VGR76j)5z$u_Aqx0 z9gS_nQEnYwqo=w5e8#=*O1d-;v0rTu``+&JTAkIS;spa1@n>g7(f`~f5BFcvt!c-- z+h?wU4znMC>z%50N;P=zRQbivj;!wg@{Biz)Rp4mVwu?A2WzH9Ag?=fPRS*yTpCN= zy+7o{8gCpw5s3nFI*J9%r7hn`@@oH(!v=4j{YT>bbu!#j^6`WDzb~`C%TYb^l7)JmWg%$;LF1 z{gaAi@IY^z7+WxhbVtOj)wfDwN@^MRV@;dwFqsg5H zvU6;)DDHcq6FJR7zR#VR%u)TPg|u}0DZ^X%AZ-Bm15ugqAdFG<$!_$QW-VHHk#&AbS1CCHXuh zcX_)+p3R}>@o@xd&CNtgy#n;EXCumz5}8}k8<9agdpwzeitF=%#x^pf_Ybk$@!?qt zy_}{D4CREKiF>Crbuy{gV%+Rb$ZxluAk!Z^ZaT!lPU!%*Ws1&TAVvki(xl$qQr2 z!`i;)&%N^wP50Q!qFKLWUa1deB}Jl`??31=dBZR}c}TzB^jkiNJIP#v!{lnoqbY`4 zOYG;b61UbHZKg#c_*f=xHY`A$qc-xHYY@j;zG#yi37@ibJgdy!>Ke8(bxf%YXa4fv zDH0Yz-?}%IOWEIL>R9GhFNws)D)d@bEI{=Q4J0+V z;KlI>e2UG$$f^bSGQn9MG8cFYbAE%gk#N1APLF>+(qSWGTNg{8j3H!0BN3v_K+~W3 zIDVk69J%&Qip<_*W&>5Z!7<_?jI9Q)}V&i=5GTR-TF z%wkTuE&`b$B8RO@2#7g%A7Bn16jd1DoEy!;1X+V!f6Z^-rmv>Wz2gVe`pB z-#d|y)1i$daNZ9Y_Ft|vum6~s4D{i+^z~?Cd3A>O=Yb)pus;%caT)k=;w`ogu$B2P zKV?I6Z#49afP1%0wEV=p_;(HIY5gVloqXs$jfC&AOf-sPX3+KqvcB&! zUw?Z_J{&f;l(_rFlK;{NgA*dLnH;MPYe*j_w-oI=j!TWn4;Dp`P2xHHD2|_2Hc~CN zL}q^D`;3U-oRxtW!}BqEwvE(nUM9oIGnQ3hU7~{t?b|XV%-2D_{>Lvr_lC(7iJUf> z*jlRq;R_l_kT?0$aPr7k$v^JT#4O%#-!|8hUX{Lz>W~j=b3AEOmVqx1^HIB+wWRPq z={bq>MOp-Q-(s$PdAbHBG?i*COC*NA(X>~QIIQB|_dETtXeo-sA9C@X4-~x52h7bt zr3~Jms+Q86j+k$Y$zA3~U@pf2W1j*z7bVCc=9$*W4u*OgeQJMYv)_lgx?Sisb8*De zJ;7+QREJw`wsh zEb!c#AcN_5J2aJkuA$^#_UE8hj6$vKx?g7bJ7C#1`Vi?29CtSd-Ye*Xi%F1Cp)GM} z^fEl@s>7?}IdEuJhFJ?^rF}TPW_BS+U(dX0U*?~VWPeKHehHZ6h)>x;STse4CE@f8 zRg>9JMgC`^mOAp!%5*bgQI8C7$P`9i(q@<6b#9#{m<`F-_rGzLXrF?phfJlN&1AN1tZL zAo%{FNBei#PzPFYa$}MVGuffSh!8YUk}I5_jgD?*nEd{LZ1%9n@S!1yNY=slF&jNx z6zcIO_e%xxiD$2p{pg~{Xn*DxIWbqdFhL%5cR+AN7)sxe<0Efqe9QN*PLM144rJ;> zu)&;!;R|!{p6_$i-gtTEX%G7}=5CX7T-`1Q`)e!Ifo_QsSY`+9giv~Sm{aVZgK^8s z&~`f68}4JqnL_buwjP7Wt z;Kc{z<3b1Y_X&bpOTS@M4g#8Tk5M~GY{og^@cB^8IzmrhbNT`Ed7b<2lPBvOu?@`a zO;19#V>~B$UxvD!m?!?3dDir4E*`?yX~X-3Je{E=PEL6`V%&}pblJ@J$(n+?J@4ld zdJ^B+WBct8I4N~dUC&091`74i6rBtlWsiQNgYoYt=5(iLw z@8t7c$rmrQps!bTCgS{ zLAEz?f|nu$Z$gsbv6Mc_Ze(dKa!-B;*`{XhCyCbWDq5qx)`#QN;K7m{wy@&gATjJj(%V1A0>g^xd=xj%CpkJKK zuIa?Q`4E&f(?NMK8!p!^n0G2x!d>ad^bSHd)^;Ax$;O0jWy~BqC@tW?wM{5CzhsVc zZ|2C;qk1~!fb_a;Pai-KYTae7eShBP{VlAM@jfAk+p$du{^H;3UAG+6_{Dti0Oq6* zc0kthAo#4%p|FfO>`5Fq?$9&4fd1BTp{U1kV--D;706fiTN5uUoE+%f2|=G8I(RMS zI1uw2clO4KO6!0j`e6KXhq>YBauCmPsm9CwlAFN4S1F#}@jp2X}Lvp_KW`0~43Ujdzjn|O-Uc%gY zMS|Qe;QdT~wgInyx&8F#`dIM0Z@esE_S~7vq4?gCq3nQa=Ur9S$a?s4@{`k?zCJk$C_q)(uOF(WiGJ;*jXt&w}vjN%W~Gs=DG zl-}7VFMWQmkS@88)fujFo@u*k%&C$z6#}wH>7vqZRDbkZ(pDSyOQsKE?+Eg=0y}BvV*~=iC z59*{*d-KgWSl~$u8B;Be*jvQ2>ohWs zD%P%@RIvAS!huOnIMtN(hj3yY2RVOrHUApRO zX9QMq!s6ZZFp`aIT$Sfhjhs>OxC)LBoY0y-|1;0<>l}54^%2%Mk~MhIJPcdn!*DlW zgI(uXL+}X0gko~=cf)XVDEIm98cg#DhlMrhkJIVj85D*|jy#XxIZ0M}IQo(?-t{yL z(X2@aH4jJcROU&448x8)>{I<$^FLYEC4)7%%GW4<5X$pL4gK62=8uwnoI`OGHdc0c2tcT6a#dxU4k|$&lL-eTCgzlUY1Cl@L@x{)74G;8aFiVf- zYkB6-l^NAHm^a;=e}0V~sd_y=@y~YA7|@cn=t?b^p~cq@;GgSNms!@|m}^m=85eww zR(F|EXhrAFEwlZ6qU>d2tn8=QNL7j?7g#WpX?w#_c}>=SCv%j*HnDw*~|B<4zkBnC2x5KeD^BrzM0NaCDKva z#yN;`K@*vG&q1EkQMWO~B11iuh)?C7MqMU;X%@+%GcMw|5`X?pf81sT5<)G^$7asq zlwUHkfDEG}S*kM@$r)#nY!BA3m$Iha&>~Y8{}#goB?1?-PRjbg`9BqKyQ9E7zGn9X zW)|2mQ}-Vw0xp$FBi5Ox4^|>=qD3C{v&amd*}s4HTZ$6=kd;T)u%AE9KO@6v znOoS?8(sSPA=t+kFYW1VVV$%6O<%a#(j$}ahp)d_51!%2d{+A7+6SPh2W!O<0SMva zn$ZC`U-dulqaUny_@f-py^E>^;PZX5Tf14~jtO9|? z4Kwz(MIzQG3NvP~Usc#w-!Tf6;&~SRlfC{M$w~dCh38EA%WUIy4Y%QF5=KkG}xzamW zL!QNagaORj;^U={qu|qB3x%(V8IsJtt!RQKG7I^;$VBI zOt`Ngi#3hUZNw}r9nYE4S>qT&Ch<5~DgJ)yITO|{Bct_$EWudQ|77X*SY*OVAD*MX zG9mm7GjVU25cxY3NApcU3VAHnC7Simg7OY|gI4G8lsr^ujY7oFFT`SX5yH;V30KN& z=y^q$6HBk#ghHGr2epIz;kcjzTzFA{0mBOE;wxfLC!aI25F=R6INzlZKO>n*{fy7? zC_-)v)}*EuLgPfPVoM>+jf=2|+`!@x=3`Z3jiKUu?p^u&WFO52vXBi6v1&eZ4evD- z_u0*)%GTym(a%om9+8YKf}^PH>b{^HkD9*;0;u zbde$9u2Rs%Nv<)gJ;T*OBKdn|vt4Bt=sSJHoc7}?iGR{ew(WJ1iBlcrK(4*CIjWL6 zYnT(i$X;fQag&DDPEsz@MLv#nla8!$+*FZU+*c;HzQ3i;kTMCnQYKY$e~WT*nGEZv zz_{2_iL#}8(VE%RpMFbEeyzaRpq-Pj+!v;GK^T^xMhn{>%Hm zoF7Wg1|XU>muW$K?1dj{#WM%<1|6qg>A867hY{y|a5&Wu{uh0*XN(_WulmE*#TN&< z`C=aHSNQ||(J$5)!-ITbe(H(O{2C_wYH7mek69ROVCM8-@2+itw7}9~0xrAo4rYZ(sp(x6@n7@10>oA-?kambkls zj%{+G`81xG$~kLH?vqsrxai29WGBq^a7NJ| zuF(GC9zEQdzB6WIat&v;a>mW=E>QTXVC?UNh*2t38cbHC^M5@ubT1Y=W1O1`oi37H z3{_zyof*}>sW5S~3XO)S5W=-(rL`)I=ejV%$r%9$op5&wp9fdW8>2$dzA(&Y9m!ESkF3Dix~Dvb|C*4tHG%=VR#b4T4RZZ zTp3xAQyP4(yBxi|$SRH`+qgI!9=pOYo&P`XWf-33YS4B$*M!x=@x?a`^BaUAZM_B~ z6Y2QoYn~||jxc{cV!zY3t)=T^Jw06}IvKhC3$mvNWgt1m^9J-xrSGgJdt!q1aQZ>! z(Nm9dMgx3V>+Cy+KJSBM8oBPP5u`_z0eaM-$0f$B!)?A+-$VljZ`Q*mG#M9a7?G$n zp!o@MA_ti{)L_*~>J$;GdHKJRQUGnR8P{zfjQ zcO#?Y%DUbLGaUWMHSICu*$QTuf_*iS%r@ova~Gepe~cN{HhDN%{C_-Sa6NZ9SJ+OD z?sb%{hg`)up|xxr>MmPW(z!cYiO1u}yT>W8b+#3zBr744hNAShFRmVCj|LgJayG)e(1e=qE+`kr~?(qR@`x`afk_M3Xn@7Mq2{XC{=N znT1tcn^-u0K9A?Pd9DC$^Na9h49BJph3GYfzDSOBPrEtGl$&HO%F#JK%SF_5SXP|p zEH!_Z%3t5fTioDWcZ=&(lM?f4vuCD^j_;#%Hof|<7selIGxI1N{88|?7T4C2YuAuV zX-Yn>ix!*CGY|4Gy}4v%hK$HU+-(!Kk&mm3EI8dR#MEI$SXHNxXS!VH6cpm~bY?zt zol*AERWg`+eZk-^vn#a~Yr8h08ES>kJ*;p(mwiFZ4*hsZfzqMmVqa$6t>Fcz(;CqhIWK zXh0T({|?~#TFLc!pH9*E!FBKZB=#KaVn0A$CZ@V(VKYC!biS7p-HLG8s|fdb@0_n# zga|vXAL*|<`-E=BQ^_)SwO%yilBH!>s*Lk>!RSI4#2!)M)<+i{+2M+yInJo$POt5U z5L^ilXQqh;sqZ+(#c1%?Y9lhM8}W*q!_B*Ttmc`N{;dIT$QHP@&O;3MfSwujHgU|T z(VYHQ*38F}El})GsGp2gsPCLmsQ1Mx)V15`WYM)lvZ1eDCern1=$0Zz_Gt!uR^eG= zSA2AKfytS<4uLMXu#5~wDfjU|=tv^-(EmEe*Q3l_xJ{mLqY;hP8ByyaJzM$oCS7Jm zLK(-%(Pm7a$Z@S1eX$O?h;2d!!@-Q?Va)uwLjH_w!BW;C_Ow>0oyqR0N7Fexn;DSX zlBGIXhjuFZB6+UjUZTR7udbM5-3n{S7W@epJ{hcS>#d98QD){l-JrMY4*h+e`PyiRUa38I?Nnw&aE?hsqlEJ3)=aH z<2T<^5SbJQGJ6N7)4x?a9OGk*aN%bae#C&683trFH#Q zcSaSS(FBz_<6bQN%bdgi%%7+v5O&9i6yI|cb7qob-!3^7Qbge~ZW;vOVLE)&p zT!SI}d@4*eB7T?=c_uvyLkv*e<~dD2Gfqw?mlDSJMFv0fxEakun6*l$=lfiRx_1CS zs|1Dm5qZn$%s729)?J)J+KS_J2dT5nLC%hMm;L_EQYYIA85RX}-0vi>BD>c>i2;8r z;dP6yT=>C;5%|&z(7BXjyYh{knam(53GgT$u4|EW(U-oivcpG`L+F2TE?Pb9p z1*$LQ{wj}qsPrA!y%;3}lD0S@LTf;dc-bq%E zZ7x;Rt>sd8W@lXSkfRlyvVS4~`**U}^JM`3 zJxmtA1N%4=wV3V8GlOngyzr-c`8>}G?s6YYHIV?vP;)Nm%^lvTm?Hnchpoc^xI?0Lv7oOQTOD{doePXQeVU|VAoG*Z_Py=7+k^18}1wefp!w=>4HZmt#@LQfRTWLNwe*^Q?mB z3f3LY;l&*jbIr+Ea?B2Op$B>@_b~b*R4XY&jSKA48qa-)m5W@v>?GeGvp;u>i!5N4 z!k0bva>-AD+=CX$oy%)dU5Pu76zI>nV?`roOI!TeTSA|fE&%WNd4=-aXWv~dzFcIE z=tSN_f$U}Trb}~nG-kD7Pv+7r6m;XBj@Rn6DvN#T=kR4~A^LMppJgn9rI5azeVpe9 z6=Cyp-aoxsi*1pcENbN{j$d0#Mzc1uCs2WIHRu<;!1J(A3ij_<;ow>&YFGurV^09` z&ifSCf+jOC&wX= z9-OacaD1L^#zLNJj@ZX~#Qj`U2v(@=H!9S2%y@qDf?hqPQmy0|Fs**FG_69%ajioV zxt)8mUF6|Q45Da5t~=WW4LA38eBiDLHBOqNF1cWqD>kUFJrHL zv>wri449?*kF7M|`A_EdROgr!$@5vB)n4VCQB;?i(f5Rf;rimLgU+jqzTnoLev4qMP8j0oloP9M>_>Q=*5?7xh;1PLv??EpAsTm&{Y1D`+H#GNMCS7`{hD3bClIaFOJNV4tamet z?v_C|y67alnUUE*Dj3eGurAdZcZWFR1K;0<$Ij@zn)Ph1fo?1c!+6dU{>#`OHz^$7 zv_=T`Uq867YFmqaWo?XD9L4uHAP-+&^SpeL8Rw^P4K%@w-(=v|a}Eu^tWdAuuLWe_ z@ALi%e@o``x>1I$N|sjpjMA{NUOF1-pGeosi&$n1e08RSN`>^Z-0MDb!4qbd|NDgV z=g@HWtMGFh%gpI!;TRhmjz_Eogg6_}!$ODuS3UZ$XN>D7|uTzT~5Yu{m?7f6IsSUU2Cd z38#om^jcT|Yq6D(v>)=GXJTGfk*Kyc1C6#8K%3S`UON4haY}DA4jz3{SKBx3q!V(3BgR+p`%#vJ<5*kAnN zQv?=gWnx=2eQJ*zNeHc(W3G7NSt^OE$P9!}E5PEiMsjVz52;5kW?xPOem%`Vh&dlS zeHzMBZLyrY<&7N)%ov))p7<8@2ClM}O5}qM9`Ql*a?F{v&BWMq?=ay~L%H3EdCKR8 zV8Mm$=w_b@ZMy>cBI?UK=JU>DZgLCfNYs7Bv*kt11)gssF`X@v$2?p=p8HLU%0O^p z0RnwnGLNl9?v3z1g$0s{ykdL5GFtC~QIaeY} zy8EK_@<{wFB_DT*dEYJ#}fu#*fbPNweNCsk2f}ukNbRxE&_)F1n+GoHUqxNot(k&+ZO@wbF5R8k9AQ^q)Go0 z>0L4ezTYCzfjrdGcl2OZYa!_KTMCwYV@bzIwC3maWkWvp9%&>`w|W-P{hyt&mf}IBa>O#2-uozo-^zr|Fn%t5TFCBQ z#jm@$dG(Ip*OG>A3t@(3yHCj*nKGjUpo{a-@lpEDETF;d7u2oZHL-O5B+!P*VPAKvgy+-VZV4%0qTEhAzO!) zNYyspIK=A~I3N?d#}x29%|@PVDV5926YtnK5<9cV^A4bo@?ljTi+u(rRU$t~zOwI*5((ql<`H?r)+aK^>oNbgUPC#U zS0YcDd%pi=1orcF6y#4Q@xC3|n5FZtgdtOwDj zd87_=aPHem^)Wvsfqu_tgCY@iAQJ=o6`<)t8~OTyx#Z;da&Iz^$SDI!-uY*f050k7LR^4&k4yn`ajR`iWa`hw3M5FdMb+!}?zl^j{`mf0w(WWnv- z^qOrTvv4v5d&m#o%E`g*z7{N6xlaQWfsGG}^G$pB&`%fIko?_)Z1`O+gGbd^ z3AA=X>by{VyT}}BazkdZ;O`pr8@_YIu1-OiQ24oH`CjUKRou7y81; z-&G)QIB0adbTv8R_Q6ne4<&awDjW85m~UI_fJ8+)p>B_0EJ&o6FoyYzH_Pys^?n(| z99YlWp{O!OhlF6B4ad-T_W7Ws(*IcN40Cn6=`nwP4zr4QoxdNHvs>*^@+cH_d+N|M zmAS6L798+Nl!?s6-qJ7_UX7Upz9t*flP!216DMOAIl$$wAmkm@AvZD`L1qgA&n8I! z$QI}p8ia$TN%%;P(qW$k+jQ|V^R6RGCWpW~jXYgw4%(9+95g;b=InC9!h{ga)9SF0 zzPU=|!mIN2YhK8iYG03KL4FOtj2||iDb=j2N1%qOvjPE`k83)sHH@m#k_C(>v#shI)JeZvlktaFXX(IDK)5YoP1W73`{2<+Pngo|ti`a+PtsTcTqD*GeYU5h^L$v+CuL*%Gbp~vvgr~n-B)FCS%1N->; z8+t^_1a~ED=?(OFq=kKP1}3JK!LmWDgpFr!@W1}pY^g&pJ@cA*e|9|^AunIkmp3N} z-}}?g_$M8k^rbMajh55jZD42-2)}hYboiT&SLF3doMPm1DRYf^AJ)64#l~0UdFzs2 zes@H=^k8yy@=Xbs-Tvq> zmR#gg^1r_1E~`h2`wjXEnUn5F9?-2beXJKsk$fORvMSkON7X<)TtF{j81KXR_4i<{B1Eut=FphwR#H2o4K6Pwtg(x4z%m(xPqiNBZk`I_0W za{h-B>(|n6_*;vWYtqRoaPM_GS}e9G5i*g^w-H(#-<5&&_Ixg`M#-sOHu!TQ5DR8$ zVfBkV^5imPrA5lX7q(bJZhAS#$?CD>C8v?I-V!O@S6BnP$u+l$gYhGC$)A3=H77an&V8p0-j#x7r^+7qI`# zG6PStOHrv?l>D7)4f9NY_|~N-?oI~!rj?>yS(IFyXNx2A12La0SD$g2*xa8v@_VAl z2-%`aXFuHKd~w2$oV9`Xl_^ThLT!=Q*dLv5X|ZMxpO-cY*G>H*<;WCUyjc~5_D6IW zbUp)PK9}O~r6aQ9kuBa|<@LYA@qb<>9`O7BfBlTrN5vZac6hlAe4To+WlrOim0PS_ zDp^%Dlud4DxTJn&*j_8t@J~^K!86S)W#9?5!6u=;VZaAna`_q6Qw~l)W=OiT*QNET zwB+F~!7hJ>3{2VFV}U{A8(`>o$C6_9R|fN#HHOur0=u1QT-#u?;iI8b{cSGGlc#hW znH-V4aI#rSIqTeHx0bzD-pdoj}Vh*la`(Mqd` z1gSGdD~5mLq;6DIS}^->j2))?+mR<>Cc-Ku_CL47hGuH0Ym-Ohb9rIC1CGv9!)Z0M0mUFYmCeW7H|aS-x81>wnwZzS>rfAU56l^onLFN$2zSZ&+~NXT%^O50eaj?)ZzY9p6$QZBR7f+ zvO$O2U)W>tnO}dW!#O8Ce(>zAWHNI=3i)@^nDbSQ%wuIeocS}GZPa0iFFia*=v}DA ztgq*MhQ}}i+ANb^EqZgl@oau3>lgN97R%^Re8f3%6&(?Ynb_x(g~#_ZG2eoI#(m6@ zCjabIF$;h5Goks*9t4iB^|R^nIhctq2|PFI&Y!iCtYag(6E0+8+44fbau-;6bqRd(XVx@WKPw$krxYccFoN~Ho@X>dm=H8u7!Vwp-_thW>2 zKx^rG%|@!Xv6UEi8yOJUN@~%0kXYSH2F`F2e|xpOCu_B-wT(PZw2?{fWFDop_y*Vs zPTI&@vXFgxIY`^=4l;IHTj_AnS|;vxka?A?q}SEPGP=A{npL)wu6@jKw}ei(m&HqE|x#dOXbuO)-;ZLp>9=A9C_%4jBK)02Rsp*;fb_l;h<4&E?~_lDgBFYL`^p0phqMIUBNbqo6+{;F9C_kF{| zU{Nj{&l`}bDj*9rkM&+}@=?#jkV~IUky|)Uke^Dw#9YOruPwq+cNgm=ufs6OijKO9%zEBU zZZX@4VPqTo1sdTvG!4@(Gw140Dh?ht!kwSTcQRrN&mJbfVqWe+BRn!wxvpZZg@2~K zNkvkADz;3cU$LW+Svy9gu?}405&6fSsd&oI7xH_0kiWV-mATX83VhZZG4ZMqUHG%d zaj&ErV#Kr^M%*YcLGd^j39Fb(dyS67`gs^M%!Eyq>2+G3i~cK3_~&dcuAVnxBLBPR z8~Q06O{kKRi{5K;v3PuF{Sxl~gr zaXJUF-`-lj)wY&Xu;4=48{NxvT24NM! ze%j_9*t&>5#_FDMzUs+*RQe!U6Kpca3v(NIAz0}}w~#02Dlfd6ABJt2VVD-qX9!_9 z)rI%{xiB0V9ELtK!{|x~$E!MF7|D93uXz~8@Oc`L!E@7bWOVwn)=55b%^5O_>HKpw zGox#UVb1}cyZt2dcsdMod-Iv(=ZC)YInLuV#P6NOpa0H<9!Cjdu1pxF^ds}b?;YMN z48Q(Og~bvh(to64g*`dLFnSvK95nDU;!>s&7n12+OrwjXl@Z0`jQF^lS#A%F_)-nbkaA7Eaa6z%?;a)+0_vY>1QE&l1FJQJg%Eijx}dG3>u$cIELHu^>P4XPaJT zor{w;Z{j6og;t{Cw32loK}w&qm!?ykjA^fx!mv2`Q9&oKV|7xUIcBPJTIv5=E7j<7 z{7rtbOFtEc3Hij`_NW~|_o9kkl570ssPMdmbtTp&tMygE>!Tf}m9xXIU#tzDCF97mo_k~Lp<$h{ zT`0MUnRc-JSA~FfDzq}QN7_*Kri5x>-kHut?!8LGG#CoHylZRFh3mhLJD3kTSp(Bz z4L18}u=aHj9U;L;W@{k8Lc(Fu-EqyfTXU{G%t{pR024THghrlX&)Xmi4(0taLw(Ia{ z20bHO|1~*44(JYDC^nTxLN$(w&Ww%a-I3F4xjv)Z5^#ctyC=rJCmP$ufwsE znTQ&gNk0@F+GHAA88dO~8GAwRX2O?y<1@*bs87!EJ9(0q-`Pu%Gx+q&E)j^G3y!-WVO?i;r9n-Q?Qh&TTT|zn1&?YU6 z{D_h3a?anI_;JdJfIH;3Sx0x{{5&R?V?rXwkEZmuhSJX(L;v5CwzBC@C%JE@mfVkO zIl1waFF?NW<(Ad~IY40yLcG-;s0Rdf=fm z-ASkOQ2wo>+)8zndea=`#TzR*VC^X5T06@38k|QPo1ynGb3AsTAG{JXJNfy=2i|C) z^TdLVzBpP$4~XME$-^WCI<_~% zt4K4PNi;_wuhHEKWKgqwFsqL@+LU;s(I6jGxkVT9dmnTsySQB&4$Ycy)Z+U#<1zig zd&2RabBsDR4F}H{@##q#E*Fyr$)uxk7Fot~CIlPk()9U{lOgwRBKN@S;~nTEC-*vv zswp|5%r+9dTq&LX%#dGThHY9iSnes6({oGZb+Q7Fv~(-4_rZIvn`e3WV84pJJcoR+ zy(kP5E^^*H%*@wMWGe%9V|kC=yq2kG>urSj^fVk`CuLzQ`(nnY!H@i4jcX=MviXdb zah$h!AN_2Xhf50_BsrnIoKI28DZRC{3u6z~YNhAp?O3`BO8Como zUi8N5U0&$;%L}%>z46h}7ppfj|9TeluJv3mlbQL=>vFNpZhSRxEx`Nd(IPTMyl-k& zNyFTxX=q9&q(MvaAM;FzcH;ZSHR9Qi%zz`~w5qjM;>f7ye2V8eU%WJbohUc_xYw_1 zkKT>daNE`vXUL@$)pvm65y#iaAk4o`H_?6#QaFaTAe+7V7=5<{QWr#N3z)0wk-?A$vmU!t8i75k+U+;LC8$Xw#5q9&N^mG z4^EUn%)GvOS1*<&dg(}>@VU7fsV3$t{#L`Cb^Hm|1Cdj~PYMjeZv+vjee>C=3c}5Kj z3p-q%9gIsOHMrI<7~`5~fRJE3?HP=%!u~^!>0L{7I60fy(>LPrp+y25yUy|qLkF$A zd`kb|7iMwW+XHhQFfWc7Im=WSZ?g(P9fPsQE*QUaH2>pi{8fRk@eRlQWz19V5|4EY z=^<<#kB#J2x|L-jm7L7RRK9QH=^`W7*nLSh{$Va=B(u2F`El;9!c}W$=9)f{yi6Q< zQ%Mx#Wxces(26Q0PM+`4$^*3;wVl|z(8C@UdO?MbIpKK;aGi?Uznk+qcb!i!84rZGPvF$)(KlfU4Z!aKUi`n6ZM zZo8mxy&0r%T|lnUjZB9BNS&lMq)R$VD-HU_%7<*NTp+(wy|O)alR53o*Y#qb8sp0B z;a05TH48$Q3*;#+gVD>#*TlJc*m?FVl<3j)dpy0XoQF-!$S~t|8Xu1Q5;iHAlgB=+i)G>!>BAa_4_eY?w_}zMrdJz*FP**NaErZupTaQM zCJduvxsP@aM+eSfOEespx3HIpYw%L;RaFDnclUsOK-nf_KF`J1PI;)DOxBy@&z=i; z2x!w;zRhSar^G>OzqXf7=jiL-)<(t-Fh{M}aK}%6AGi;9WNyL<<|*!@b7?jGxi#1i$lpJV<4`L1#R=OvHXcvI z@mD6i*qeu+?6oV)pktkVd@s%Na5BAvXts8d;6$}Fv9ysso^52%s4nvNz8QuU@Z6=d z8CJhkp!sWaJfzq6*EMg{4QAeS)CgQy;tP+8?Afg5i)Y{2=XEa}jg{f3{Vg23_}{Mw zaDKgFgtv|iet9yDZ7#w5Huov(>5P0xhkFKHh{5E$cjcktz&t$Y{uvKnw37v~ZKbMD z8>v3rNw&n;NyFI=@*~F#qxjKBYmOuCCE_|=fh+#zSQ^Xq#%;2vEq(E8yEnX3d{Aeb zFCH%nM|{OFJnkEgwY)}yj)r4#=iM0EpZ$@q)6k|-8uk^C&2P`SbSiV69ZXQ(GQrA7 zPoy0^gxq`VB4?>N(^h6rY%gD?sAZqEjWnvLmd!e~j6bS?AJ3vnBNf}Nev>Vpp(z3}M<_mubP751X@cqaFfobRjN49C%6Ba%JS(5W1~ zjGRk*^<~eeC;Jw@n=qB<3g2h2zmoGt@;DQ2)XGEc-OTR{S4xL_YDu1IBmcxXivLDy zS$mtWqn`rR+7`>m*St2NJnIS|r`yL9L#@0qsizmtk7a)V_q|@fy>Y`Y9G`oIW9o)5 zBqq?s>>G}2<#>Iz8L@)zSs%iK)#Du$b^5D<&lzW{`sKM8C_6c(; zESNLBBT*Kr;-zsMYfRVl;*zA3szG$aUts%v?cet>Idw-i0L)Q(5;adPkvGnvzqiP4#yD_&>PJ(q=)W$eeHziv2L zv^^OL*U8poz*zfwMgQOAUP;pKRia$t__LGa(6J^7GLHMGh&%R3kK~-u#R2|Z)R;_X zt&wNvLph%=U7^9l7OU{$G2M|5=xTgO=X+~r7W1{JPU*0}8C}N)J$g*xoEFZtH^=C9 zt1>ZRHaTjZ$5!BYophxPGi#Z-{v}J@gDkaz{JTRxGuK6r_4512F*!IrLH=2tAiFrH zPJWOeT@P~X%VOTqAo8A^*ISQPdwOcgU(VeWPE7@-MV6-@^fqtn5Kj+dLzgdr% ze9rA-^tfE8!{vMAJ=?LbeG4HS#;!BZk+<<+B+2<1u$fJe1t?EZIz#uLFDbpRtcWgZ)-PTx&$|n%vKV{z4YBUa~RZ z1f4b;%v@LIC|s{`E*rW;;abwo%yk{-^dHCdGNB4*u@ap$;JvdhS1-zH4%nEk#{I8! zE+17PaGe^i$5b%v2}1dp0K}AVFSkR3vK_%Ft+fh@S)8jL=`mqcJeK%yUVqAdvsQZ8 z7PBs`$i{{rS!n8>jXK`h$nKJbr)1x+^-#FhWr8th(6M?*fj(_r?P4AH=! zbJmTntQ!pGeZ+aI_z(L9#_18y9<}&goY(u&H>zUp^y(}O%g=%>=P&1JTm!`_TrZGg z^k(nGo`L_5XDoVbA?2?XihGG0o=y#A&MUoa4!LNhXHKhYvApWe^Sf2UR>)0da&|2o-{VUT_ z-BGSy7>CZ``QZ{N+2@AvHS`-sry}A|F7|wADh-%}ykzij=5B`I-dLWK z)nV?(+~(4~QK4*M{_MUVp{SBg4r?kopb0JH3H@UCo_Qj@To}YP6$`I0f9I^Nw5?qt zi61-=%QNpc3id!f&B4Tg#?q5Hzq#Mt@nd}`?yV>H_fIaWEpH^dW)zC^Sx-zO=UDum z9z$pL><+P#Jwl!_ZWx{N%(LFabL~&Lc&Kh6yUD?=ec+Cr+e2acz_R02<_@>0C&|N^ zRnyiJ{p$1F@JT8&nfdQ6YAW}){gI*qcf41GV%X9Y%xKQ@x(H7Ds z_>a_oG8}JxLa|Rz-&{C(LytysT3^U)ayNXL5sDz*Cr$Q~6Rh4$wucqS{Ok0`IfkHW zZVIXm$;G7U&BXG1p>&z#j<$v5?`9gH*hTN#h88j+k7@3wJz=aLO2;GfyF0Om*}jR) z*jXqkv)!W+@Z^jea)@+G&G9cw9u z@FF?2!yPaDLr{>Ag7d!2*FN4qU!`OGQal7jjhm{;Dku`obRCe)xOkv#8( zXx{&dT-MWCNQ=RLWnzLmKG!54w~z1FKip?8Z6u8w7Ko+79ZnzUhcHjY7xKSr_B9m; z+rRQ=zB}%{qIa);Dvs!K;M%;EG%qNS&J*3x@8K?3bWTN8r(C2AZZ3(YKavx0>Cqq#wBL&CEmrWR} zl>A|363BX$Q+aZBHI3NL=lXZBg`DeJD&NR0_P9#_X=na>o8{u>!UpmWJ&%j(df-fB z)`BiE4|;nJ?k=;I6D@zs`NM7~yA=Wtcjjx?&xLz&Gda)a!h4q|hI9$VqCu(1IQt1F zD_O`KQ;8g{Nk{e}@^rjU4%>09^0%3+C|4r8c>hX2-$(s68)m8(%hY#n_6DUzG?Jj#erl=Wfu2VZ~8YkCIre@oJGa-G{l z@GO&D_7V2g*JvT{?i9+rT5fbLhvL_vRQyA}yX0;wnNYJp8aDO7x|Z}^($n#FLN3f} zG?xi{e=W#gcR9gv=`;Dt=o~z~QCITY{S<99?>9vlj@L`Y)k*Z6@;ZmCE|7A6-EcQM z6h3?CfqnG}E1fMRmE&H+>Tb*&BL90X1%IC9F#o_>`V23YtdDNk&vDX$*KOzX9JKFb zDgUnjBg=+zJggatc?XzZPcFM?L}Rfz|3}6?cE{g2p?Ec({hYPwuc>NnTiIjlON;oG3pn`!s)SGnPZ{)U4MavU%K#vyq;q`sy?bgYp8>tji z93$oWaU1A7$kR0;Ulzdn^@K9!kVJ}iRcm~$%iP-!T0C4yA9NM^%QBOxH=^31Fhh2_=xa+5dtj}P77;~#T z(+4-g4vRNvu>XJ-PA4)@lbl*aNsK()Z-+|{{LrU5xkB=HT@IJwQRQfHZp^&t*Z@4} z!2bB^Qu0Q1dcWWR9ovH9I)Y(qQxkEu6b$U^qQ-7nO0cuagpOrUYO^ zJiU8Lu8muekJCrVpsM7mssw>X94sL>;5)Ju-SUr0V?8-aa(|b$@#lwTpsQ6GcH6|t zr7U_39r-$w$h&>dz_j8r9G*Z9Xqpns>Eo;4pS?T|JV!2NPVvhqX{A#_^Obzu6CI4R zGx5`oT+*OOX|q#_QA3z({6LHGkJ53MUQ53dk#gm}4Xix;k;VMqS0(8@*Dix;ZHz=% z+G70`Ke)Kkdw4t(c@@gI&xnw<%%QHAy%N*DYte2ExxZ>WSNNAanzIeY_V>rRtvYP0 zo{4z=dq0djC=cl$TyZrJjXLTu?PEILSLf>)A1M}rNYUAV@i?zGfMV6 zumNraK<>xldpW)@Gs!(|ij_31Kt4(X++Xp83=e(-W&pYSRA z_-qxf%g@9~g^M=0*_~dk-Q+QO|L8`Ot7;M@^Z9cUCk3JE4=u_nW+K+1434}$Q>!cC z=Me;7@@s=eWH5)K6yLHUq~a-h{pi=5xkig?^)m3yybMd8Mao25Iw4*L!r>3Sgyg^0 zhLRio94To-=+jIKz^IK{EI3F`)}Q=ruPAwT%m%d&25_CD#pLlBxZju0OO-fr@5Uak z$AK`Ci`@1*1G6Ga;oU4+I*<##*(DI3H?*i=&Fm(=&Ku;vek`|znz`*Q$?;7i*B0HW z45OMv2*qFMvBM9^=H&hw@qTDcZnRO9IMKV8Z03hvd@ih}X5iIig{!e@gp3-m#CK&N z*75o3?URWOyq-0`M99Jp^mxu@jV6Kl$h<$lsmsu9E&01!wy5kIfUa8RYp>0K|MfE5 zSsEqFQf)BePaq!f-`lm6{>pb{=wlxvyE@t75byuJ!{V^MN+y11l#=_1mBq|$A5n!l z$PKhG)+Tc^ikxXmlr-<6q|29Cuk*q+M@czn6=LQEp+^OtRkEHEL=N=9 zt7xe=L&?kt`u>LSdB4E?^dV(*AI8f2Li!@#1;M@#eTC+ks6_tPm~}+vGcP;hq(3Z` ztmm}K!0xJCzw4r;4xgiIo&6C$M~ACB(~*CkK312bGH|$xz10ECtI&Zj9+RBQ&^9|l zo{@hX@|K>^W;%F$BiBj)V5Ou8DQl}lT%qMp_ zJsqnTmtk#QtOOrcqF;O<`o_lLX$0R#Jw2ES{Qi9YoZkM}LVmVcwM=|^TZ)crV&$gM z27`A5qDw0sJZogaE}i~d=SVqp*ajy#9?qS}UdIf+PA^_JzoYWWgX7Fne=LjDqVptj zn)KUN`w=7ank(_GdjQN>!%HUj{d^gD+e`d8j!M)#;g1_paY*O$xMfr+4vdVDo2hm% zkP|;$M~m`h8Ns|@`T>Sa*+JvLgrQcx*0ExT59FaI%Zw>*NS(I zczL{DjS2QDW^>V#@L7dEj7kq4>BO52IA@;COME&+f_PDs*bC#wj~{ zc*LmDh4qXbAxc~wtH#;u{J!<9g|`hx8tWMQrUvp}4MG6x(phF2o+|`mJ?qL#9tNQ) z&+%(mFf%YggN(X?sI3pe;Fiq$Sf)YhG!5KrnGHprvHpCXb#Xmm`&)zJ0rdBD3Pf6c z=4;hsUHY^JA8V6YtU})o&!1*D(qP;mW`*n``#6Qab1u(+-Unfdj~)j(-_~oZN8uqI zb~RwuUj}oeyYt*7M~fAA*;8sFtJqhMF^%JhxbPTZfmPT0G|eFYC>WCLL=@o#|X47x{Id z9-*W47^Ka_E3&@LD`%n;>jR!HnaJ9ig`wUV@O0<-%ETgv-|dCw97fVGQf|sVX0w`{0R2ZeA!LXZ8KACzLr}bgX;f#b$bV$SZC)d1C2Fo->zt zA*;SOvXs8K$e*9z+6O}mJyE>L8y?p^ahl)T-~_oVdK(Xue=^_7n#G_nXjvz)>qA#u zd>DM4!=QAbXJ{S0iHCNh%FQs?WwSOPO80zl7@6N%h;T? z534dVRpb=M7KY&>&)Y984a2YpVQBd$41R0LJd&~6TA6uPbD0zQCluo*gyHiuo_~+0 z^RWl_N9R&8sHYJHi;W0+XT-G&Mp*A5lQ1fcwK>)=F4JAnnCIdbQ!)P+{fs=jar%}D zd^4iL6LJf$jj*|9#F*`@{raV%_DLhEgpg?*YsBwrM!b4sgza&<;^va!DoaKAW=2@K z@_gWn5z&Ek8nAZs;4WQs4bl+2+64b0CVcQPVdMcahZ{{$4>w^IS;Y-&Oh_7GLeZUE z%pnU^{w{ebPu90*<>GM-Iy2I9af)XbHLI9#P|g3x^Ll05Jk;EphkAc(`w zg1fU`Q&23W=4RL)#b@MtiS*I)xhg7_m6OV3Yr_(G;?1n~!DcwWhOWoPW+=_)9#_d) zVN@w|G!!W3&HOYzW4(AbGontJMD8z@+@@xjcc%4pXXJ~XpiOd zQiD9>$}mJ;r*~;aI70QIc)v0ft#7eb=M>H?4AwGBnblPx4EagnC}OQ_ZB#ghTn@wa z&pfBS5{8rHF19xd$If;1eg)Bi!P=*Fei*#Vk$oWl@Lw(I*GBqO=acKUr5o2-KoruqC{vW@llEOu8#DrlDOn6?vzGpsjdE59r@_UAFGGTlv&&Fnw1D;FY$V;Ac3^1Xs z56_k8unC|iwLPEDa9gs&=W@|&IDL*}9h(>C;*4b;5^I{^LQW>k(uAz?w+xZd&MsG) zr5fsM<{J7<6NB%Rk1h+oE-?%})w%oA^W$9FSU)$cO=)8oP%+3bzRD=Wf<20q$GfW~ zZ*@?lEV_8!;I#JT#o5gp8Z2+@>K?zjP4^8yBa?e)pEc~QY46fC+{tCdiyg@sN8^&c zzWW-MM{F_dn`+kMZJd+Kl};Cuk5(}zxBI@x#s1(ogZa;Nmm2PI;-b~bK)Ms{tjQ{V z(90&8OdKbS-ae=#@t`@d3&f);Hk##A3<u2Bm!;d7V%tADak?@bm=4cOCil673J;ofpxIIJIQUiMkYzMqMLftl!QPv$U& zXF44->2hFx8P9{dPS1pO7`@-e`1d~3+t0t-@(I1(i?ZOvn&iS{?iH}&E= zacm|I@oQ^rvXJ?K{cOLpup=iE4Wj-Z&shAzQ7&Gvm634{a+AKKezhEAZ**I6P?p2w zmnBl%m-9ugIjp0KMfchaF7Lh2jAL-icg&-7@-_S>rQVI8OC)wA6zT& zhRN0&%{-VDx*!Y+=Wv`So9?oo?BEdA_&?BrOYXw12K~1KFJT~GPkycuUFp?JUYdtq z9FKN2&V#pA9vaaf*)PLhUTEJ!pa{?kqlBs$0>M>`qX zw7ulerFm;dsnl{+;Po~-%Ck!3*~wDz$ne4tGhghai|p_oPxNl)je16Ja*N?e{tgOS1bsiGNnb6P3b=xcUsNCW88s{jNo7hRE{nqm3qLSGM4wA+ml0jUP9PUlNa$K48 z=9*_yWiy`HnBzKKRA##q{BtM{4^uqKA4PwyBa+osbKy{jgogNyr>t9 zg-z&YTpf(*-|H$1@ibk}oTzxzuq7YfjlF)S$rp^y!nktTJon9pfn!-S zjz?)^9_pN7Eq^i{hA+f+zn zujY(C4zMOmKZ^Xt89OyX$;GXhL)TW42Fm&DvE=yQM>r=K^zi2%{*qrjENkkqkbC<} zP06?lX^T;`J#r|a65!?p0(;p?z2RV5kce|UXsz{nZ~B=8f=@Y zL8MnO9$wYsR1W8Z{_$wAL63f%TYk`r(3EB*N2(+}w7DBWM`YI^26ktOUID-Cz(WaC$!4Y}Im-wkR^Xu`f!@-lU& zGIN#u;yu1c)#?Pp{sq~h+jJ$rXYFPaYaI1??r}CAe%08^xla#<1mJG||7Mk+c$|rf zcgW0_r(g3g=b{c~t_{bMOKGKWb(*4Z_0W+|(I{NY`6fyhGs2rp(8`-le6JeCOUt4p z39zS|aWmHsB|Mi}t479QHQL-(W7K%QKV(qbb3Px+dD`(t5H_}>f2&ZB7o3+z$Hn6f z=gG6R^{6$>}zj@>#3~@*LR!9gmhB4{#Umu zVZY?uO?EPFj=glA+eSJkwUsmT+R03wExf9vK&Rg381vU0eS4ZAwyPO_erC@T$Ky`i zPh6!Jv1)U=eV2H`(k&cWM>s!lOg1yny*`5bgGXWbm*er3!D)~|X&A(DxtpUAdtT7b zIx!C^+w;(jW8rghd)rgFR&Ha$_TC+2^y@aV=T>uhxWi6tBJAbTWP2(9UBPT)1%9k3 zl|x<1r27qiUfv8>`}x3das*P&dE+|I3NB}puXbdAz?V?O6^G-JuqWy~GaB?^ICg_v z!>lw^iXulHZ^WA$M%@0$J$6DGHgHY8xOyH|-lXTeCb_gOCS2hCN^BiP?o2}e1k7@jGOJVWPvzS)RPX6!*+!aQS+jcqv&c5uyu?@_v5 z7Ug0)_Yubqk*_@4MxHdVmu|kcQu?l?^j&Tzhq9d{g!8Dmrvf>?e`J$miG;T?gBACc zJ{{@h?@Om|yeF#j<3W-S>RtB1XwF+7gXm}Eyw!>C)3R60p@<;wsiYs0>x@QKFJX3F zBX+4Tp?ELdQ1!^?eK)~j56=V6ny}HF*XXecp@BA1%f?=!%Gt^H8%|P7=&l^fp2Fc~ zSa8Y=wS7ut)PPcHzeItl^LUoj$_wV)W7ZwxgL{#l*sz27+$yq!+z&c0-;MUw>4DA- zhkq1vGVH^#gX@i);5011%RV!!H1;X5pW>$xvGSSsBE4yxGj?cWv4#<6DbpRYhvusQah_QAkSV_Xw0;#z0*)-=pCPs3G*djOWxu**+jqs*PYa5dD6~$bKyd;2wm| zn*<+wbX~;0qJkidt{#lm!#VCWBL{YZZguty^^9TORNHv8JD_KMLPzc*9xaNQWpf}K ztBy0*<~=>NR_yOiVefXf!gbyyg=;lB{h_@R2Gev`^&YDBe4g8v*x_##)*an6h^V;= zjm$Neewuw-+{6+J193?i|TNUw$4jAPbGw zlaq@lYfk1|(?{WY;sf)+A~=tQ)BiU-LB1;Er6gV}-K)}{;G>g(?g^qGGq{4+=s_

n zGkHEeD+}FwWMRr}))K4Hhqx#UVxe%YJ&P{ig&dpLkSE}Ht-MKQ?@f}lwbF|@*Bra9 zu%Kg;6N-ayc4{!@R%2aYn1*}KU^w*&#*DLc zAT5bU);c8pW%=H!L(eQW7 z1DvgJ-MN7M9AoLNyqzc=R66N#nb}#~v)?9@zk99<@=}dk$5f~nsYH05JwofM@#GcP zJAtdvcY82$c<(2vnm}pmNE@XG0U|*{w)cJaIz_ z&$*tGhZ?+%XDUq_$crCE@@%0yzW)lPdz|M!>vEyF%G_$>FWI)&9YX_{Uy?xo;JF-l zS~L-lN_4E(_vHOc?<~)k0*-$~RYiSS`Jq6jSr3Qn#}K6TOGS~Iyv*KK(x-8WEIRH^ zCMFcF^aIY>k^|@2O~i}*QN`Jwh*7c!I3N|1M&{zLQ!|NqQY@Np?x?yU3}eX;9$1`% z?siRNO7#L!wPb#4PACSrkk|X~-}R!dTxPAnME_%&4SR~ar~D5O^|jDiJp28XGirW4 zf?mZf2CQwJgC6AR#`EY53uF71;&rT0jLhj?e3sW?Y6>nk%Ef9$ z3)U`5#DzTF_!lAQ*@L-5*?j%Xryeq(SQgji>+cncZ;w*(V`C2Hudon{_v9=8afh=v zJ(vab(EZLqs9QtX`jt80KRr<^oV=%`p!Mw>)ack$_E#yEZ2sQADxT%9O68vS6Etxx zrQ2U}i&N--Y{J*yirzh5x2GR1rKsW$xtZ^ddV~1$`M&s9WIyoBhVr&nf%vrc#JJ<3 znDr$UV_b9LJlaxjz9S(4nz*em44)>G^seVJ_nkA z8cJTLzf$ifbDZhlJW1YaOKL72*;~rWH>EOtfIDKE(VzGad!KveupUBxU$Z|lkgv0` zmbu=1zb4yr?%L8)HoW{RXO9g>$8Vt+wVn4BzwVoFA^KB=^2ON$H-)diMhYtNe)Ae* zDTi7VOHB)R%=HXGmr&*fd-C67)*YdE->n_shktP7P&dW|3H~cE_xn zp%@aJfV>)0#Zp&k(%$Hw6t_fA6wJa+K%vrwcsL z=0gZJKW3h9^&C`JSjpabMKW}l8$t>~@ZKkt^LP#vzLwHp+;7>imYEApm}$_7Yn=zV z*!Ivy*3$DhslXGBjUi~r=k9&^9OMVLmd{6ji`PLnY$y#yuoL-K2cGF(wvZC~6MyaJ zbCJZnqNfIU@5+Tmj-^!XS;+c?2NsMaha1Qo=Q#RO^IOQOM}H++;Q_nrA*h#QU}i}U zT3ED@Tir_KSF{J5bLnaIPQkp{IaoTnvD8f|lxBTB>GvjA`!fY$VL5PL-%`A#P@a-2 zT-BF3VTx4LJV~GF3M)~NUw$jYp~(!v*<&df_bCVdYg@>C@}d1}dtizUbE5y_D_7>i z^RA_gxbauYHRbaa6av3zDQMJz*V(&;Y)WK}gU`{nFaP;5Q*pCF4o(!-m$mJR1l=aQs@bGO2d3E|XT}`-_ZzXRJ7K$4=UuOxy$Q`MuF_c{MhWhfO_aB)R z;)y1yNLP}Hl+ObgDZ1TXY+)(u8{h&oEk9m37%cjMQmw2zTb)#+zqesSN+S`^I7fTghv+crf@dX5cDvjY(nqr*e4GfKnh z^?Mp2J9gW^da6HueWF{aDqTPi$lqBW5uXAZj!}V_xk!f}C3{o?Rml z-yGTF_&gok>EkP5e(r%`N{oK&kCh*_=-DA189T~wCL=~Vks~uq@rU`jI0Qv9=eMvF z#Y4&Ek$d{KGYEQT9V)cUz=(eI50VG;t8Is_T*rO*$-L<*^ayF`eftz90y$ zT=R}dNk_*9r5Mp8M&94I#gSHl*cHWG)J$@JZ_4QE)yey3N|?w=4Ve~)gv;ru$bZ*_ z7qQZJwGAA|8D;{IrGCGzMyyGRbGHaW*b_ezoT zEkca+omE-ok6LkB#Jx|)ejR;n1ESV+8kKZuuU;^}*tQhww?@c>7dD7o83;PU5i~jjWPAWzC-YD5kesjV{dH}m?ncGHI zWG#8dj}go|uth8Kwx-GC&gj!TVkpB;|0rp|`*XoPe;ggCLv&N-K$VtaR`VD+yuk+7 z_xqzLg3CXFhGumlWl0SsCff51D@=!>*O}A(xD?x*qh!6W5=BSp*E_65)%XmQ zye@@P|0s#zeKmFRz&#=-{FB<%MRT=j2k%I~pZ+=1LUP zOSpzV|4d#6e#Mod%0EZt!gV`DvYvB-yv@u|zVCmS8-65OlqdP`O$)?_b2?nAlz~Ur zOId3rhx^I~j>}o+IjTj6n;9r8DW!WVQlf*D80sE?={2-SanHcgUu8%n-*;N6#9VT_ zRaDI2`uq?T!{}k`6eaz)StE&l)z#DK<-C!Ok>%MhyE#Js1lwYi6&)G{T5Q@!p89DS zdRLB+1&(&8G4ubB_SSz53#G<5dCxi7^f6L+Ke&-7F;86~Rf6HnpZ_}Z z5cM`tU-ev^+*{#>sc)C#%PjKL1{01(Sn=|BtPrBcmJh+GF;#~?QM{g)t@v%nc`U{a zZg0sgHqm2B0PkZYeaU+!Nop-OJiopi(>oZ@X0QpDep;}gcD%f%E~?kn8 z;d0y=KPJdIdpC3$&;QF#hu}2oGsamlX>B4cu-%}kMgE%4d8fJLQY)|*KP*<(Xx;E` za|n)nPC=EW*|@sTiqGUm*9=!;@W$!BV%#SV8`*&}a{$fmp^qxC57(bjSe{S8(Pv;K04N1%C*5&-M;P&Ye-Rc-0 zo=x)dzIes>`mcPWN11g-eZQsWhumhp`U+!+Z=%FHB}>`2)YZ9jNbJtBpYW7HuthK5 zUM9=T**Y0BP$%OLB+0$wsS?JY*P!Rbj4~-=tV#{WLV8NEPTjMsPFjbiNJeeFxO^~3 z)>@rB*_SE@rt4*Vev()oCd>CZ2jwj53LPrD zBk3t?3!Fpue^TP)6Ez~rQ7eFq<9DqZ``6Gv8Y;9LMx93fZo*X7Aj+#?e?pD3TikKr zxe9~JdEh}aYCT4)(X&vET6_7rWDm@q%)jeRPr}h^B=>X2fCsFLzfxg7-}Ax?dRE8t z7z-Gy$WX3Phrc+nbuM)pUxs4;WDUB#=I=k#udurY6IU@d4`kklb8@X=1~j{=$Cea5`|PRpdyVTF z)|yvt&|{~L_2muJ0ANkJ_#^ci^?KH>b!bsY9Yz-eTE5XEi+Q6*jp$<$Wx%e1dZf28 zpu=v)fZsY8nYXCfm~3QSdKEg---55-#P=I;nw(=l15C&Dxap(E+p6?v+MSECoR5cg z&IV5$t)_8q?wt!O>nFi)v$5(kWB2}S6m6%Mpi>U&ouyQL3xuO-pM)sXe zn8V*<%_e(bLf1a@qJD2ex-DO`kTnO^iu}vuz+axn^=Kk^JLBr35=E zrMJRGwx=*RJj_YHH};SxUtMKlO;=H;c}RmV)O}o4BHyc9C3pe7-k$RF^b)E5-Xf>S zF8&)&pXfw-^~G7GQY#B}>TGf5w*pSvEHZYzRc^K`k$-9_kSPkpvPbRdmQwCNOXbFE zGLSVCctXv&i5;l>*i?ac)5td-P~d278@!}e+`bs*A`TTxC~KIt-t&DbD6nNw>UKb zD+7Y?&j9Wrz3EfkfqFd5Uvzp$T{!nZq&E)4=eyK;Eb@nIN7k~}1)-$G9~Za>YelAO zse&wITQZP?Sj&CshmBRZmzxxgp53*Ww3Ruiuk7_dOE27S++UZWMjSb)v1Au_e2<3x z3~~ehT5RR(C*RUyrG>qc>8wk04?Vm!wHxiVD9q4e{7W*8b}{S?qEBvJ>OKZ)IbSdz zz}(SUel)4c_u_FL#k1F}Ewz;Rx-;{%$mQPU{v9p;zDW&%Et&LJ$;9#6WUXx2(_f9; z)bmUv?a##34H-z?n293th!dErKfFB?wbH0B=a7ZjQ!=pWIrA?G8Thy<6N`|Am?l}U z9AW*XkbR4q40yO@;_=l?jC)LO@>)84;xaI6J@<~xv#)X?LphtCxdr5}W{|tmlFxcw zfN!O&)!fU6MX1a8#EfGzsFheu-MC=tE({&( zsh{O4aT{D^(snoT=Qt_zkF#VCZ!Ej)n@Z_G8D`r|PN_Lwb~%e~ zcT@4sah2ZGeoR+2l_$-ciS?&iA`iHU`fw9j7~EXSUviUP0ge*#i{53&$P(VNNQ8Z< zXm*hsj<(8;0;^o^bqnJi5q`Qspe6uME@t}7rfE3WjG??S$J2f6_ zkSXT4nZt3leS8e26w@yvA_iG&$w55VV$6At$A>Z4!S`?QG79VOYcb_hCejB}LvcYS z_KnEI?r`P@M`hp*$C0@WJ;5|&dL76ruFu546J!w+GWi~v$owM{FN?@B-eX_Kt&q#bH-+xTjjUE1#fuZ_bGo71k?nT^iRb{peIl`|fGJJPuN z$Z6y9>3+u1)~Uwwvo*%n^nJ{@s+UVklBD13BpLjXd6(y@lERwNoSyVMqZjla7M-}z z3)0>vRm!lZIT<^mEP!N%RI(_^eRN-*B-z(g@a8^wLAn~hhN&>T zhZ436$P##YV3(g7QHSZ@HPHiyQk1A)q{hHj?oh-kabUCxS8LMOp$2jJnnfyzN27W`suqrDIci)G>U8}*g&l+@m5Q-@q!r&YcjFJXnsLMUz za6hs!Ey8e{Ye9#iFl?B?bz)7{_=ai_RE4@^ed&L8APm35LScJV1LIw4K2{A!%EmBi zvhg*eG>GAvF+;REd1;rdV+O>QxRx-CDb+o+&!3fGdakLmHA zYs_pL15`5%h3mOn{{2eocC<@nUcdl(t;gQ&28{VL7cE%#%ZJ=?0NR*t*0;D@NC$4(m#|u_&Y{=@3 zU&?tdEEC^3=O|myBbf8aIgb0$t_7I&fc*+zsORDDCKac&6VGt9ge#pSc#cx;d9;(w zR_X}nvj3%~4MtwKLEcJRZ2Hp%wWbFEr2!bZkRF*@_M9Y=p}!h{FRfzGqLk~Lr&@SV zAb&oS^YKe99;_rA$6krf%d+r&Dz%D6(?575nYm%~PbLrd#zZ~DhyvJU+0{|dwtzW?mKfq2(4 z5aE908#@Kz6Jy6muB&>GXH4X|O=4W>8L7q7h)g`S<@|d;6RS998-{0Lm}?eJJt)AC zS_K$?H=ml-`FPFi^k`Z>4mh@wP4wSB749MTB3j9jrfntRw}*6_VS`kq0yg_f#R>(c zKC;E;400-DQJ%i%dUYXvGWj`btv|l|(|7tL**rUHdGDbvnU(izGyTEmZpYC>nYjH| zCh8P1R=mt)-Z={%)9F85A)lIioXfeUDrSF&W6O`w)cc6aL2YDg*Ov0dNi6|Qo6Fc; zt>yZ%Hd3Xr4L&_kAcy@&OMI*n-Om<^wmdJ!_BM^!H#CL44Qc!wOHWg-m8%zP*?Z1w z!)r9TTnt7I)WT&Ic|xuq6?uGKBD3g|K_BiM^8CDaja+zbHs>R74L!lR4m?X%ej{1S zm*zGyA+MzjrVjnA&=xY}aWgroQ&BJ5B26YKkTyVpB?GB5`r9Io3%G|ENLGd%$ow+? z2n_SX<=5mH#|Pp0`0WT!XAc6OnH?j!7WZfG13#YFUO)@-lrD~37f&S9NLEIv&O%ak zYP2;kfMq-x&lP0z9mrQYP%ko;EJ1jxoSsaNPHG|gh0)u2?lJa3Qk$`p2U@>SqBXg% zY)=mqy(5d!N&|b&pPx?Am#7x?iI#8=+-L>T#--9fnDz4l17?RCkb9GCb`Jwy^q`kK zKPvv4gL~XJ#$C+Df!FlNTuKgPm%{rCIfs4JN_u;UT7+8_-Y0i67jZsSZvUeb@3VS2 z_3WVR*>^~uT;qPfSdF?Z+z}X{hG%)Qd*7*xm`>)Ld;jZg*n5~4#{4w*^M&la4o`)u zssS+{=q>V#+;-hm_BfLRFU&!o0&>;obAYzF__QGVe|)fYJeQ&m3hxr?NS&Lg@NTkP z;qAq*2RWw5>0SmINS)#pJM~g4kY3NldPyp)hG~&IBFef$|I!`Ho~dDJ;!gi=4c2Fb zQPYc>zYD{0pmjKoz6{4c&eM)tsfXxK#&aX}BKxGG?>*`@j>zR&lf8e-*iYCu8^5-m`tz!sx$FR%V+90Vl#y!^MCp%p@sRV z)1&juSe<;ioGKx+4D$3S*%)4*smImm-i7f#RSgIFZcOV)E``@~LO>5h3i){FmJ6WdpQ~k1ei|4LQR8^BeSZsl=YijyyNUC>JuQl^^h2A{E~2LKWW6 z$(bBR*xGyQPp<)X-l~7~rfErzQtMN9_9e(ZI z(T>`g_w@96T`5VrA~3%b4jq z@Hijic^#ch8D25FH|k+V;=JRfm%-I zwv>5f_I$=s$2X39*lM(V;Pu<4CWF#)Gfe{qq<@tnps!pZScE3eFJT8%yEfv`Kf<1VB z1M$3+x?dv$kbln)^~U-mhS$TNd6aDjxwrEqXBowwwJS03Db7M-qb$TP&qBXWS$H`& z6T`n`A+s5C6HB=ls>i;7G&9Ct=RM=~XHp9JGhaonWdJyFI^;HTU${av`Vop z*EaUYB;Wskyv|HTfS}B>WYF za&O6iKFosGs4U#&wJ{!NO#POLwd`+;OQ0Wj1IG8s1yH=nM_+e7KeY=G>6(t|N8{=c57WagTCk!|$n{5Zw~=gGfMYplVFFvc#=aQ4BFM|(z{ zSgx_{d{epKpdR{8#*Mq=;ZIY~w|*|YOmombg}Kt3AkC?V&>$^E)OFQ3 z!hHMe2JY-*q9%aS9p~%O-+3qJLSCO+oC}+lq384i_UBIs$J_nvPw?P87(fmA`_x1v z8`rKE`==@}enrvi$3U%ivT>_B^IQgVp58$1LDs7~{A)!=#`td@3hyK`guj;@7F}6` zlDuDR+ARu@`LzeXq@GtTZ);YKIz$c^ZTbWbDe;;H*M}6z;G3 z-VMiyd_5)xGnUq)huU`o#6rJDmEAP08$$ z(Yw^$#=Guz#*OFf5xA<8<~33!im@Vks6iUkJtFJL5N=QKz?d=gms-bKrkgw3-Xxo! zLcQT24aUW5$Vh0=vJT@!9}O;6T7lnV*{{GD@n|piYVWCAFphh#1A0`8%0_7oJ~wHM z?_cRzUM?3U19I^05#z&gg}28fY8~_XBnI=mhA6xbBvPA^UW=^7NqnJBy00K>X-yKt z6c2oE<&LKbZfJ6sIy?XHyjHlw=}0)bt_Vd$oe;P)mfda5emxcaxswc-c-w%%^;6OB zu^yFQkg;e;F7|N_e(^p%9hig3tr)x3(NBqAHzmWkpj6@QK(6skW9mhc&2`~D{69Qn z=*ng?kU8-X=OLKQUiGEf8D!neNUiH6^IHFuFehK^TcX9qhMdp(nW>3wC*}Vtk&on1 z&XVtYH9P~cZOoYJYcJN*?Dry%_Gt@`3$`Ll1KKkp8WRsEkW)0dZiZDmYKNYp2u866VZ;ah{5cK z(a!XHeVvZ}qw`R%hO>C)TI8>@{^&cDI(H4pOOijb-fbu~SW9Se%pcmx+>hpH9x zO%iyziY8b-Vj9YVD5erbpw0S-}ZWaS-3%gwq4nCy^X%lm($_9 zClAU4_2txC>RNUVKzElYg#S#(?Y((8KeMrP$h62x`u5IT9gRCH(y_gP8K3SqmQzw9 zOGf*lM+*7M`5E|U1ohFTHIktGaJnDITgvCP>^9<7lt@_ApLkcZkbjQP4ZZnEJq z`O`PlPrOe4%RU2xEqtzKHNTJ-(`k@T(%is$1 zJ*Q^DWbb+svaeV!clE&rj-&gTtU+uxqkm!paXwxm4XIZ+w=d7XX9gM%CI9%czL+K! zOVJ!Z?CTzd%X>31HkH0IzntV);16ltoOzCHjz>PvqiUHE_pGj5D9e1vSwDKIMPp0l zbc9zlW5tZd(s*W(WRR<^QxFY#nSp-g%~;#IzLblgkI^$;pX4ZXo{@p)4f8NVI@am-&#NZP-|J|CY*w1_5a5K;DhdbEkD?*z{;5ftkOgTXpsTHlUvZ zbwxJ@=b_31J1K2$5l=I9E!R@N(j|l3B>llBG?XXpev6WNroFSGa4azct9gB{pQt0< zsi#?+b*G3(a+IFwh+N8^^b1YoN?x)2{h2zLypO9Erc;C3jPi9HGbUE3Ef?sQozyJ=2YYCd{UHPOIgW0(Y9OKAe#vw4uo>i4 z!-MEcUdN1+q4olLww34jE!Qg=zIW+UA8AHOe-}CIPCZciK2M2{#`!-okg=Vda-_S& znu}$6Q~IHwj)Fbsjrbnq1SgUYeepxiQzvvJdBEsu8EC@sa;|v;8Rhhw8bjn3Ymwt? zkbxUq=ika{CL@Zdqf#;mR8L2wA``x~&Dg;F!X*1&lI2fb-9ynh@GS#3znQU1 z^e*H4u;{L{L}vYz#*Vzsm9@BikUa83>WxyX=HjYi8OV9*ts`rCJ{h>>M6Hi4&7|`F zQaL+~zTvi7gimIUUrkS>9u3$>|67{H_;Kw(-ILr5G;7c6On-Un#X?!g>)E=37I!={ zF#2EKUp|K&vWlecRA0oAKkXBdjy%SleoyS>o7y7%!l^S`KN_z8@Hwwwre#5#+?q?h zHs4Uh)zaZBgCzDH=)dH>LC^03nJA%CoN@FAU%yv}ZaqwB*x7=(Hpw!4j*_*FP)ztp{%EQRn|@GV zY-)-qn1iq0J`9t|6KzXpOGL*WXz@ucN8AIGO7=?>MPVzwE@()CUZuU-NKscFo9V^+=NB4Q?2f6O7}D zDJYC){+WKn_PL4DQ>DVQsml@S$Ll#h8~fR_5gnBzZ+5D&n7+mb(}f*zv-V#-YWELqAWh<3hlok=vhME^NoTM&ZzifK!Sh(km7mb>FVC91G@q-?@ z8%^jqkZbOL$!#@u!=|cX7&e=0;(^)Bp;$5fX1v@^QQ^i^`b7Ka;ltzjHll9hz(iTM zpT5tIp@2b$kIdVeY(SGn)VJb#drHSdNo?qb`}AQqmC>U!YY5kVSs;yLrRyG7 zOs1aQeEz?+@6j)qJZ82gR)%#~;@uYdT{WVL;%_G<5 zMb2>|byT~%;dS$1Y195GAJ63qhTaDY&|r9A8bYYum)jfok-J zJraU}CUS6mo^`xm$qf%kF2}p=vHzd@d-vRgUqM#1X^|*SRp}SoHw@{csW18DA*?A@ zR8hrBr&J|coejhCw>o^{IBmJWidW7_GWQ=PhF=Py=C&T@3fZ`~+Cp8IWEtC!{Oo}c z^xsOo)Z_p8cT>l3eTwL3F(1X}E&mn$;(7duE>^@3N|vdqDtP`3!MW!;_NqU`sJY~+ zhf!aZI}u&^(k{b~?qHM@$${S4FIIA<%9Ww0?#sPf&uk3%%ZkStvGQD_gpTj~xCiH}&eSdSR(St>Oy6*m zD+s--2U=5!9(lo-PHuXup9x(iQm1k~YpO!M+MVRn z1~4ZZ$NLiYzvmgfpMNrL_j+aA(xid$;)X*;`~0QpTPklfrnK&4v>sjPHSqgnujqR3 z(`xmMGHyQD`+TPMTh{~kY}0rAT;b&q)-^q=dZgF*+SR(PF1(O7`|TR97JD9^-~Kwz z_+84UcZ?kEnRju@xzmorjMJ{&cy|(YP*IUfs}1wSDXtRB0F4CC6fM9ld0iTXIqN=Ye?9R|jpZZDic{7>x8Y=XMJMtT=F;S()pA+1v&!R%l zu1bW=Qo+2(1C`IH;q{2UgrbJ3whBke@wJE956Yg|er>6_7_G$ldCV_s)wo`u#+(fv z2(-=R4`iY-dXD&zmgNdv`^Lg*Hg6u8h+|fejhQ4z? zX~UX=nRV<{%%QO#_kMlWh8i&LB+-xXy#f8Y>JjKk-Q`bu6f^IiGs%FRzRW58mv{R{ zUoYk=R1OBbWZtR#F6v{b4anMJ!1#8|v8<+MBjZ|YSMrL3vayHxuQcYM{_}%gI6Iqt zoY~N}XDua*dKJvyjc1Le_&z-XnYXX@lOL=<(Z~yxTI66zUN&Z)&qbe3IdIxfZJv6p zS>MP;w-xjn;qQZ%WaF@bV_ZpJuPo-Z&Ss-s1ih?lXXDd1YC_h`##`q9H$<~)5XYtsdDZ7`5^#&;eH)Nm-4;2Jil zbe45c_V2BjVUbQZ*&ljSfx~5}%lP59oY_($lV>O(^!9T-z`SmdMXr)%Y_y1dYr_<{ z5kbF##jl&PO1Vh zb(OwE96{&3qCgo*tF z&?Ag`3VDH;Z6aIsiM|&*0??f7qeB~dGJYd#wIT@1+6Uludp`u-^TUp1{F?QY2x`;a zOz_9BO92?MpZakPVvyg4bzScB@A$KZ@rL=IWz=GvK|RH;)c5Jm9Qh-9@~zWi3BRA4 z$lN(|HRZNzQRxGDstheO{m4E}rMK-OE$oIf&rjXPkhAoPTEN=%T-MW%#=zNuT6D~B z&y9>huU*`OU7$`7Yb8AzX;GE0FP$92eJ1PL-_sFQl#T=MGw_2s@Pb{L_{Ca9UIH~4 zf--U4jowl-+2`*zKXQs~voNG- zCTf3X9xRieJ7=Otau)u&nu%F|@_78)Xy#~cGS5-Gl`NNuc?9M{@;m3l>AV?V&3U-p zj$XFW%(wGrp@YdLE~KwCbMb9Xu)gh@j{%?ZQTGa2EAH<`oT3-*X)=pP^YPQ0?3C$0 z?VJLbSpS*xFLmU~uohK5AHHpw$DhaF8O^9rjsAtVskd>3tQPmm<9D%Eb(1+DuY6n| zN8N(&Ja%_?@w!Tnvk;Yh+u$yVyOmOAT{8*2kEk|D{MRUBF)F^hA5p`OL$7iKnB6D1nVHL2?ZZY}aGUKdr_FIVzVgL4r z`X!Ro(klPyNewI{KU_(HFMY_U6qQQTP>Zx%sKCG|tN0u*mYm@wa%&8A8r#@1PS~IU zeYQfHvc}X-f$Tl(RlUSxHL}vD&?2wsEwja4!FisZF7&<0JY|)BbrjH8O2w9a+S^L} zFeNDv+8Cje(00&wLewI_T7&@R>&3-|fKtpj~4n{r%b4aL5vfp}rVx**3`(4+ut z`^GW2d?;qDBcHs&AHi1wF!&zpl&iIfjflqepcptg#^4*Dd(S@n`OYYe*&mI9`qV|e zrA1{GYls{>mF;3su}TbT-HL|(0lj-VXpvG7jhsR)R=3uoadI^5m}A~{UW*SGSzr6_ zSY&!?TxR}sx)vwHwMZ_Z=gfE305!}-e~LyC$L~4jdA8Qi#OfpTue-_q$&p!DT8$ct zCo^IBL|+r;+SbfU$1~O{>-8b`dz;Kne~vfuiu!@%fjIsg%2U_Wl`IVNMeQ@P(7>0q zJJvW)aXi%-N9LGg=K*uUJ!g_>;0 zT~*eFS2Qj_MUF2Ef4``XV_Ne{8@+Tp{!Y7NevxL=+C5#bXrI=v)c^ck^zyn9QODTt z(_dbZlVa0uoVHJ2)P9H2b?{?P)qsg!?$eUfew1`E#;+V;9Q`TWsO@^excAmHuX(L2 zrANE2H~usIUDt5kGUH`kZ=>O5<8+t#{~GfzWf-Hw4|-aL+NSUQbD!tf$UoB!&B~=m zS<9!#Xnq)%rO;oxfkFQLN?q+rsnVC4C1VZA@+mV>j%=d7;{H^zQnx#8aIz$_FXgbE zK@M!u$(h^KQi{<@@Kl3rUzRApo9U&Z=AcBpO_h^BlEf_~QO2>x(vlk9Cw&rRlA3Ey ztwC0eOp^5t=vzI(AVp^q;)#@{IJ+ z$WUY4Na}*jq_@~-H5PUAfV!;;Y3r0IeC3Xpz38E}L5=ylRB&CbWKWYjDqmFN(_-p) z-%?}aId_cVerv`d`jZ*eC>qY!zEPvbKK9lOVP9g78dbWJeN?kfr(=DNxgLN1?QHKb zsCtEAL8JyXx#rtkIUHMZHE=%~1}AF>`mui3X$o^x7eW!wwPNKbVVKCeUg;3>iMe4I zYz@Puq0|OpKj+8(8r;81-{=KlxaO?E(8y3sHHYE+UJdG;U>z_e4E6Y$rEX*+D~I9L z5e*U^k(X3*y_l&%swEW0PdaQ&V*lzH9S+Y(MeuC)yFAt7RTj1FcXN&BPHpZ9WKQPN z7xWd^hDY^Kmr`qSkO5DYkWW0PM{BMty(iLFI#!Ruy7W5>G2k56f0ITTQ06;((EcH- zQi=NC_6Dp7A|J{8!)n$fk0(%XihuLeWWeUf1`Ogl)YO7~a&@>?TWvzc$Jt14mW%Bb zb8w35y3O1Jf9KjT!HK#s&binal7sq+T;$Bp#<}opOk@tH-7b1>cF)G&G4v`O%bF`| zW^c*EyzE0Q$6@rE=CPKS@b~sP*vPeK)M5H`I+J~@LPm0BHf;G3S(&fr-<~12@_*`R zy+fVl^7U47HC-uNyw!5Jk5Z;JRZ9Cm$mi`X7RR-vGPAT){7JoFM=i*1!-^!C6oJeMmb@O%4$WpUr zaDnqi?pHI0Q4?{~X8PA}AfHx~y2-~~<;_r6c|O!h{u<{dJKi*tqtroe%~<1~r$FY( zQrUV~fzM-Y(A!%9GyB|Ua{U$AF$jGbS9bgkMAj(sd&$(<+C+Yl>ng%Dxb!bI8c%b5 z)0=Z_pDc9py1<_HEI635;1t01#|wHW_sT~L&S~jacrIKY_%9=aZFT4As-zP8cA^8_ zWSzTO#@^+6mT_@-pHjI~LxHX;1qL~hP3fgT;TCFa?G1p}f&gq^6Np}e>7`sL5R+b0 z8~8r;nz~TuiZMoCH3qY`l85IS3J0?oN3*bD@&yzR%ED$(&fAak(cdi}lE^*^@(xF5 zo1x{L>64_AVev}w{NXBpU2HCUR<#tr4E9z$vqTfxGhFSIGW!xWEZ?`3JE1Nz^lJ-QI@Vq4Py^ln zhXT7!(gQoPMAq0V*o#ij&MJZQ!eLxK9Eb~(0&!B~kNEP`N8?)b@@d9jUoDz0WAA~H z{Qp`lB7SGWK7d|&A>{l6GO^)&Cff1qUK{E8#_RFLKOcMPfgSgdOh_j6uFk2%?V4IX z%xEp4)mzAkDE5prRmp&08|?73!KM8Q>?u^h<(3WR`74m13xH;00PLIs;r=85?mzso zaToiMM#TW(F?e;1JwuG+h9g?OC-u$0(ub>*HNrC zWI;Z{_U1$Jglywwy~I%G4}Vg#_s>)btfrHJJ#-STW{&L+y?N)kqiZ{IV8`gyX;00h za^ZNnHw^Fo4#n!F8Z@}4!P|+{sO7xno@9U*_oMYK>{r&OLeD+y)dkeFYLbIieRFY$ zxT*?z_kuj$- z{{m|t1uEQQ%6~omQ2V2VF#K1IO;P_*C2W<=Tu~D(c@@M z>O@|k-)kK68vJ^8Yw|-M$jmeEkothW)BO6^J;oNE&txBRjByI@XXH?8wq;IntHS%T zf!d6@VJ2+ualy80U_~`|0t)8q(RGDr)3=pkN0XJwEd`s#b!IcpQ4{~ z68#1^7yiiP8rm}p1IlLM#{PW7P2#%t7kNF-iD#?Or}sN`uw2{9=dDVKxTuz6R@cj%do~21CFjH_Z|c}r3qXl4nYbVH zzxJYz?)wD>|U~8k*s-2 zX(nn^EI_xvc^>De!_4c{dK|qHF6Kiso%)A8JY+PP!HtZm~tZ&AxzZ>!jm^&CFl z2FtIONYHxjSGgBGScbf5sXuzU(gS-6YrxaV5jt_rF+Bz+xz^bKjXi0#wqr=27_{#Y z!`yf#+^+K@g8rg8?CYvTkB0*05|%MmBr-l!rY}Rk0yvb=n^Kz(=L4>sDci}^`f8c< z+*x|^o~^sjeqO5$){Q3fey&tbIN4x3S)ivg6j(Sf0GW#dal2&z)U5-s%AbDNO@dIa zQw;uKO!pZ>U4Hhnjlaa+H$FeB*mpLH=g~*Q+=(~isUi#W=Vak0a|{W8=A#DpOZ|KE zqb>JdyQoj?*<5=2HkB*yxZWU#@1=8<%A;Il17m24qgCE8rrwYGE#pSm!rY(z0{(n{ zI+FF&aXr?Yxhrz0%bkZ(LyP&GZCch|>GKg3jW#^D=vFcK_aWnGXX<40nv6=w1i0Sl z;?4LzgSBwRtA^#NNqw*Y)jqPfV}TjgE(V#~G+BO{ljPjo6#1>vNnv?K?!{>sJHyVS1b_;=i+@IKABmBq0hyIU3QhBTz1H9ewim|lgH+Q6+W9*70>%E8hX2#El39Qq7(opA2!&t4M zb{e&N&(p7uIo=*Tuf-mzNatMr;TY#YSDpv+w6Tu47!yj3bLLuak)8g;Iq*%O!rPJa z;%w^vMJa5&Te2_Bq@mWqQZn89Qe@?7>h51P$i=VB&rea)-&KtO&V#*_9ym5zjcZ4F z4ld#Jk)(dlGRCstFpM6lK`XCRY#UAApBkx{vz$7*8&lDVabrz$vhQT|ex9L@<$zqM z?_{H%F$Y8MDZKlnQLmN^V`>I98hM?*y0Gs5jr+~v^pdi$j(48iU^?&DPxdSr+;MD$ z2Tr!5j{ihA1nyU1>IoHoZ_r>wk1)i|<~h|2=bnMRXMbyOx&!@=V(Dwtidx5y3~(e* zSdG`G+{&vmWbdL8ZUEysrg`f8-y#HqW*x5+o-D1%}35!20 zi)QKMnSY9$4@r?b)Q=q4llsP6-SN%jjvN;iHm9kvZKgZ^zNo>TkL+z@481p)8V5r5 zls^l;&v-G5bu1g^;0IF2fO&rhXT~wEH|k8x##;7tct*3Q-%1^T4ea}OBRd#MAG*ct zqnM}g{+>x~l={?*^w5jLyHu%t@u1ASM4jwgdO80^Cw+IQaig<4?Cz>@u?%&fr*nUM z%LDVz^IQ%vW{o2c%h(mdz2*q+ZC}5lUN-lR14im`+p0&;AoiOKpk~5GEC1sQmR@aTuY>0rY}xjh^DrBI+;T= zj#F20^5)+%Vjg|5g&M`xGax(7Xb|fl3FL9Qk+WO1nDg1=479IpMu&!u(lWP5Y_9v^ zmYRH`A_I$(KHzJgdZI1-EiUBU`oxo;Iz*kj$$1#sklf;=B3b3)i->?|thO-M*4T_& zzKtZ?u0&o{^2Ot{D7>1N0qwOs?6YYsr#G_pu$2AP)5xPO%EZk8a!(O<((wCt+4Pq$ zHG`uO!Jd5EKh5-@X(&0Je#$oS!+UabjWp@l+tCcwb_ZFc{KfT>9~_yhw`8Sb*R4D} z>rhWT>2rOWI&P!aGdHQ^{nF;)@1O=!pV!UtiVxnOkH(3I)D0~D0K=gAk~ra)1lRY$ zt6(i|Fpu}|aQYf|vXg3~e@G>zAD;32oyfx;BWEl$n zsvY{EyDyuMg?C!d&{Q zQH^9|_Yyg@b_nkL8HElzGoen&gU5^}((6g7+-2Uk|CMOiNG2ww=i$xz`l2pxl^Lv~ z{Kq*~2+zO<9{=WYpy%sX41afVQ!l;k&S2X_U!uy+I#y4JGMfsZ6Wv z4^L|p7Trk4)?wr~-`0}^^KZHG!4L25P`{7kw@FPimL7K!FRoFt5BXv@`QlA()cfQ8 zofO(cEaAnn@zf9$^@_&g@$}I8od;WKD1VnJkx|q|y*)M>O*W?E*o{2aRUKpy`L%UV zsE^r*S{bG3$R0)i`qTDe7)(F(5!7{!V_!cx)6tXp{HUE|b8L~cm`q;pZZy51=r2#6 z@zw77vStK%$v1u&!|^rPEdvFYdB4Uqlxo!R{O7I@8dfG}dNBhw_S`e?c9d;1=o`M& z2iaAagJ+I=d?Dwz6nn|o_d_~N^o7&eD2(dG9032{KXV(%a^-K?N8V)4)-7K z`yX_xFU8st*)qi!>z8U_-#rr^pYx#CG?Ji(#o}S-kEhFcKI_Txk?*$Y(|~&Jh0-Q) zFy>TZZA>z7Ix`Q=$~BSc^M7)T`QmivX!`DEU{@tG=KgFbc~zc`O5yrjR4Pq!hbN#WJzTANCcaal?aNXI-g{!RP-0^;NPK zkvndxMZu+XxbQsJsF>?&QY;JMiwUi$qfm={WkuGUERCd^k@=JRKJXz&*?R?_|Al6} zwrwhpzL&__*F&JAZsV%S^pCE zHf%+Uj@v*hP9BSw0CIe@JVKGv zSBJoMCj2>)y($~Xou#SpmV3f;O8O%Hdj>1PsxVOw;_dO*IZrWMM% z^id5_;!G-a{i^C7BoCqh6Nj|Q2OZv|?%SQdXRy4nmDD@jE@jjD&&Cxm( zZzq@3)Pg^m&zMdAZr;aWL^mN%dN&(20-5V*L%qvkF8CH12K9A%54AL*w=H>}V|zsB ztb+T&V3cd2L;gVeG7EXAGx1{c%M}5;$)Aqb0$VHsvfiF zQ%A1{b^4k@lf}b9i4U`a(eWVpufF6pxJKRAm0lcE z-Pqer?(BdLN9D}F3LYWpqK9>IJ*Rt`rA@$C6iL(C(Ih>=xxWu|fpM56y zU9`X{JxK~otOL>GblyW9PINZm3c0O8r;@}jPl@(Q4X)MIBYpuauwo=@cF3h7@=o_ED<`jx-X!E;bHqS$jYrCXw$awFf$ap6Ob)j5*6nK@SW z^^l{qy5d$ha&tjCbY1fhopQ;yPEC*j=jaRX90vPePQ?u|bHcFs1NA_Q=vzIKIm3@} z@?;hLj*~+%pPXaX=ZEy|qOM=Pcsa6AjgIm3%U(r2M2r ztybjbvMgv`6fcLU$J%oOeXDuh4C750@t!}Qo+y>3sBnwE$y>gX^L=eXEcFCkFT}~| zWO9^qm!k`FdsX>7*W`ZUkJse&e!8Is^+Q9dvfpbxePBGT)bEIsw3TjnwK@dT9CEY-I;HZ zdz0g+_Fif0ufmtrp)mWB3w~w7c#w*BrBK?+-gO^cAcbBkM(6r zDE!*8_Ep6M*Dx!4sS@M`{oI<=4@Jk8df0w8!GYJ|^QdIG_R$sdJh?xjPU1Mu|NS_A zPbb95%F5JpoECzse^bwtM0VkN)p(Em&76 zSqc}b@U3V$+B+EFbd2%hHGSS)lI1G7@7f$+q0B=hd1RyRzW+VX7(C)lT56cZSpL8R z&rAEAyQV!)G>&QKpSJYILr;&dM?Keni|E?gUhn0$x{TL9F^$vfS6yLL-};*Nhihuu zgTqQ=`>d(P37=M`y*fF~%jWJa&yPnxbq2 zWWU$ot=Eld^&*XXWv)03Ujx7F0im3anf`t-2Wm}wAI zo=zgwsd8?IL3X?9WJ<$>Qmz60{`%}_d`;QgOZh$Do+c@Ascn_t}Aoo`3C8*nqTLoNbKnp*-MR|4CfU2L@$OV zH+f9{?TxGMn8f*R{sDI!q26nydh`n1L*1NR?yM`jM!!^syE%y zyPO9a-C-=|I^$onI~mXqp!l^S!AFXQP2qXikXMSMNM0%6l3q@*w z)@_&v>(n>|{~u{*9n|K#wd(}x?gmuw1gU#z*G=6iUUzp_Ak^KEx?@RzQrAGJyCQWr z0@O=^0y+2I-+Xgs&cA2RbSfLd`%7MVp0%!Z-4WF^_!mr;opl6%*1cB-hGPC9I-SYw z|LMaz{Td#Jl?LaJ>5+7X^9hUSQsncaiJKnwfn*u&;xTO>>q0AZ*cQwF@}_u1JFs3g zC?1uz=}^y~{b_zrw}$M!tkH8OMUPXfba;G0i|AcC%wtXc$vs~0tMt%aWX+;8``kME z8F`Oy&6-^OemV@fL!S7l4sVa@P^B_^;_*5hwr9<~BpsHV4UH;hHX!R7iL8xnxXjwz z6J`p2Wi}w|8`*v7%W)#-_%Izq26BFr_rEqfm}kQOudifcS4+-4uuX*FZ8g8ej1hz%b*vCbrZfuferInW|Ds#$66qJ61pB_AA38=_3O?O z@|c-@cFkn@Sw~51?I5rFxXK=Dy66qfBzc{S?3ztKkHJYOD3Uk)`}yIna&k8JqFtQD z@iAwBraQ}qNsdy-zp-{y4(EMhC9_?Z^9K z)`$QM9Khbf0QNlA`ynRF2R$_O$K3YA(}O-(H-s*iVqffk7YNljf6TV_qpO48f5IE) z1Dp?K-T%>K&Jo`5$GOey`R@vVbw6MHU~OiORRBiRpcf*=A2a6qp^@GP`E_jx6j*flsiI> z>M1!Z*9dH_8o^$3Bo4CPFfxYTIb8%&l34E_6oF=(RSauM?vcNo?}nrD5B{uKTa@&Wmy{^ zMZU2Qod{!@f3=Pdf>+Et(9_$#EEq!<#0EMTH@iv40V+B9!&$tpw~+&CcUdvXU8)YY6Q>C(*;3I#E(~#(iu5oJ zd21(~R+Ax~(M+6bs-)a+H|fP(i3a@ImXF9Nk~!&AMTuwgi)9ZP#`S6oH0;2PwQuxX zv{J&>g}ejVlm(7TjHYjKwzF9dyYRZGY!+uaD7M!ukz-$rMf;On#%Tq%@*35TQlM0h z5>0v(%g5?`?d!~tEU!eDuOPx-x>4}Gv|f-iR5 z@WJ8M^q#z>|B(#hd9sHImXUax7>-dXgn zftz?AQePd?Qg_H%pLtPxbOWFxhdaNXL z*U5lvtvvpdAhXzGx}T_(-={be!|$6-xA*wc3G(}Byj-)>O2}6-kJS?7<2EvrR}2M?^D0-Az2yS8LF5m> z?8^RhbpKM}elInSmvDxSzw#cc*)Mg)wJV&R;?KM^gxDg4Z)^M^mu>QAZ@k=nt}9i|6+aNmIm27G-w#gnZy8ktPX@AZvp)zW$4%9KIlzb z&aw37oJzq zJ!142md*LSJgx=LaqUMp$*A+35B^X8?2--I#~YG;~T#=s-7O@*kkkO zYu`Gh$KW4Y6m4Xd-gxFFbYeCM>kftdo(CiJNF?8bM|7z*&cJ@oyEI##0sC{zV&Gcv zp_-0H5ANHV(k;UE;OkH6>}`|fV9)T{an8H4-@9l<23nKLnMKA!*)0=SxHj}O{*P~L zNDga7F|4<64eClyc_ zINclJD%Wo|m40Jd%B(5PW%48iG9Pih^_)47FS#z;roiAs3iv$=QAI3Ec2&tILaa`GW#>_<=S(1snp+DE|qnYIppNGuH%}K&$kEN$vSLj zUgiuX>Mrud*%f|x)7}pXvKKe`Y}j3gF74!Sv^*Y(m?S!=hekr*FcN{anDac(hzjM5 zIQNhBdh!KviM;22G9qXx{m#5sRqn_2LQfNp+{(d%EjgHUhyLSewS?_!CXS`rN!8S5 zGV_{R=6fmeGgE;yDW6pZ^nNwh`{9(yADuQwAm|C} z_@5#XIfu`h&h-3}3-PROM3v1(lw`}%1s>BT3wRk6XqRo4?>!ZmUfmxL_t8JD z;LJ|4FAiSuLuzj_Gxj_1YiuMg@VWME3^|@=WG#E~eJV8x@QZDUs%4_E2-!CodDRm*42S9F`D!1CP+ zuB}RBat*U=)G1N_fl_U(RMDVJL?|;+xaYNIue>6excYh=t-^h4AMRs$Z@OuhiBqioPF&Bra3lH| z$r~u&ai8f-9xg-SX~ml4NPF^nhxz9$h3DUxSlRzVD{Xhg$;T>m2~X8YeihD74pSqj zuPfw@8~${6MO0@shL)&NrXO>Ax`pE8;t=e9u7R^t2v!^+WBFQ#^$oe-UaUjzIQnNN zk$rfmM`snYfuA#Dx(pqNkLjK5#(ivT1|E-6cqZ*oc-CVNLUlpmY44@<sz)l@AtA3=zhx_w8YctXH7CDUW%nJRW z@LWLG--Omm&jDt#gA)~=w-s91+crsB>`RnepXu8QijgUu;^k5xYtLzFj1Ojp=@(br z;d9lW@6TFa4HA}-OBtkrg9~dIe2@N)4@KkIe9p{d4tH}hdkOKV*p#dc8J^9NY52)! zfeqi66Hz>lR?IX_WQ~CDNj$kq+it8O+bccKB#_nnt?+DAStpm`6Q!=RUe3}3_Gg1m z9_`jiu$n$JTUQ)?szMV>7YupiioX+>zj2s8D+djBC25c`A{2xAg+gl=j20pEZB^i0 ze;n%_ZaR2`>QS+FJX-!HYmvj*Zq^xm&d?FOlXZ;h88FZ0xx)Hihh7TLCY$MMtVOpc zKfgQ74V^tPLFiYLU+3b5E&@rPnIuKNYFyc?#*^kee@2kcJ*Gx{ea=;MrynwkYlFS? zF6T4fV|XZ^C84N4MTc6$^r%`s9$8n&6(#GKAsmkr_H+~1BfI05iECfdk=`l;W8Kqv z|519b_)OpE9W$msA%S*U;pw|k;kh@)R+cJVrDhuEH`}QsWJEKudC*iw>q;b=^@Z&N zEs)<ON-jKZCYcG% z#ev@A2Y;O9&qh0m=W#fcvczfDIXY~%K-M57{J$vRrSON<9X}l6{%8b`=f*vMxOJpo zp8J%yd}gJ@Mxp}u_;!yY;Klo6f|Zdx5%=F**H7oOb$K7|33&fG%4fvv_2dO+kfScg zS)rlyBPNjbW@bR?!7Zd~VLN&H!%coY<~=&bRdS4+>-4l_evk!oQn_byR3LjyiRi2Y zFm19wRvq<6JbSV2N7D7zCII!g7s?2v!?HK`H!mYl`7q}p8%N^ReeUOn(&1Z)&f3!S z3fo`8#xkjNJ>>wWv!UdA-o$79GOHZS4o4DR;B6Xcy<>&f3K4j9(f65;l`F?#3@JGd`k^JwBL}MS$kFiz~ zmJ!LmI-mFbQV{J(2mS0+9O63TRe+KAEixSMc`W4KkKHk0-^wx5sZeb0*yTogj-t=JWh{ z?tS>2IO0uTBed;rK1|Mrqjs4#2GR4 zZwd+%c<%6d-=r<)JqNHa&GRQPg`QEK&y&6A)x4z>Uz1LnI_c$;N-x8#5+zC>FXuX{ zP@cZ_XLHo(mQB8UIeQ0Z)HqR#KHs|D8{xfq z%SRo&xTc=jFauQ;anF%!(?P7Cu2y(9B)?dj&y7DJ&*etI+;9sl2)9wYC6L9DBmyTHCkV?IZ_b8Wsl6Vu0%i`&C{ zAz8G~!xf%m_-y?|KhV3Z1Q|wmeqL&#G#L>uhYHyT7?~(tpSWR4mOFlKbcOXFSIn7D z$M94a=r=N}XoCj1%23{~Ll9>l3cFDH=UGplvp|Q=tZBy|(P5(K(RU&1)I6TmtPNl7 z!}q8ZeZDCf=s%yC*ksGAsFa>tc9XHBFY>CD(zE_4GN7y2uee2quup=x-DWm;CH76L zCrN+y3Y>Lrn5lHbfCRb{>|J0y?SiLf4GJSPIBB85+WLHte$sO>QN#N<=ekDfu|I_@ z;|V=Zc8h056J3P9oVkj~Kqwi{r*$&m$Mwfvt~rjrpwolLVeGH;Y{&cb@#%EvJXLr; zoX4Dk%s9FBAYL5kYB0{!i{-UM>A%_)o9DWq9(m7)N>{X6#g zzVsb)e&cOCT#+i5?jmv;;ALq-Cu=gK94u2tgvgzzkyYtxo{9m52<_RlF$o(tBpK;#( zaTrdXOh#=t6IKtXFK+1ta*}&2|NL;?Us5postGc#iOinEoRk}bQ1?A^K$vGbzbSJs zYT0nMiS_ZG^bDS+r_3z{>zbI5;8{lwcP^9At zBN|Iz&qA4W+6QCwtc|rGFTF7fi>Fvi;jo_@YJZY>SR0*@5*e8U>@^?DM0ut>h` z@WzngtoJ=j!He4DhBjGAN!fe})-ca^b~yAttZo0!LLKstBaOesnmIC)Duv^0=@fMA zkcIwD8b~!V=8H7m=rJV>woO^DV|{vD4I8<%;IGKaLFn3zu7FBLDE+f=sHm=#ZShxD z_4S5+J3WSjQkVrzUQE|OtnL4b|Jy;B+c*q(!S_FwJYaGYXdAk!)bUB#7R(+ zo)@+Zq-XF@3LYnsYrEf2vOg5b;r8Bm7e-Ev|K5H#^Qj$e^omjgINc+$o+-wWhRwrJ9e-(`G&{o-NIUyoGp}#2feYD`QQ)u%+A=v z^Fi4_jEz{!Zp%!c(_v_xk%B9~==Z!~E4?{mu$^^?PvK#BpOy@_?k1$UGH;!;{Mnbi zaeP)7qL(qBx10%4rmjS%Gb%^ z=f16hsmrkW4-@pEi(Ck3VAOvsziNS^%4lPRm{vn$U&3OP6nevXdM8_4Bp`OeZ5_?+T?(Gat-r8;(=4^nEWep~vrrGTWy}My?}AIW3GHtQ0Id zX+n#!wZ)elYtbljh2xo-@FWEbJDX55sGd|h!W`jxzOXnDhC4hT*4@qma_h?KN=4Fi zurFTmd~RBhf&iZ9s(Q7h^VGjmVH$I~N066HV7@TdtD*gCNx;N>Io5$W;MU{^)%3JZ z%fd8wJ5inaBiWpHtUNv(Z`rF!2d``A2BKO2SE9)^yUwS#^m7VYzBXZONj(`tUbtl^ zA95vODCYU2>TiN`^?IU+E0A`he6Xx>I5M46P`-2)JRdZY!T0m!-WzY|5}1(`%zUqc zEL`c*K%RXokxCQ1@mEQ&=;{>I=h{e5uCr(0Ux{Nr`&s{RST!Wy9hikP;r4QS?O&-$ zZ}%o%M_pOVxiCKqV`ke({+B%QWlnd_D!z_W3KIGCHDA_~kd_5f|B^RO_X$Iv3(4%8 zXQ7w6v5fclC%qex16>)8`s71P^L>8P&Q^wa7fRV4zIaiFyz`i3bem|x_J(x2a6j=X z&Kv(&`|sdOZ)xu=%skgbEcAu)GRX(YKg03-Z8D;VlUsaOUk(~dWCVFY&FXLj@H`1` zn2j~Z8_VY!3REBmts*yit_JzjYhUo|4|&^cW@BCTL0-mo6TO_KVtM=4 z8wdC~zUBR@%YNoZziA*%$sJFxM?Ud(7}iE4W86pPp_jIj8R~zs&CUmX74$GprdMQw z3BFtENEZF48RTA9z6i(f`Sd0nBp*7Xp3Jr|ix=<12RD=B9+iSY08VV z#!S5yJN0QuBGU8(dcm)D`?hcvXAWk#jK{ZjL(BN{m`Lywa>tjtTt@Ot!}B^{CV5h_G( z3dRPV7K#P*pj9lv{RIc42lQH-A8Xi6~BV+OrxvrGi6jQeSEc*H*bW_rz9sG_9*2IfjP zVMZl6oh<%bw^rQSRyr)|rB0~)Ybl18VNIh-I_p&AgUDO;b5vpKUe;wsYO(tddBd9} z2rND<&zaBLg1H{Gb}|=&Tw(L(W~gyUg!#^Wmo7sizR&Rw)3AnoQ*U#u#Me<_9rL@b z8fa1LHFI50nej`-{M1bInfqAu=hfxx~ow?!ka!%UR)c!JZ{Jy#PJYlw#T8cc^bU0(L=YJ zpVtj%cx@qfHiN#)_GySa&GYJEoVeasAuy1>xrWT@WQ|-~&5YqIweo?i%ZSWi&Tnb4 zp$d6YORk+;AC^ip)cCtTh`HBV+_&YdDPOS=zFGKkq^s$aghdX(_TAL2Z^7l?yVdlS=Vjj0H9j~gI;afFI_B38=ep)Ok zlZFyc&WqEV*}c6A?KTJF%4G71ypGZq@cIosBBpvO)ZV%bJJPkR)jmd}V%Hi zN4yRpuS(AGRv&sTb9f&c7c2U8Ds17uU+Kfw&wY#;{QB>WqvdE-CusgGL;DqRsNI-c z>Hsr5Umg-O{hM~=E_K_;vrkWl?+RK6r`&<1md>v5P!%!;j!b=xz$9ZE`C5KtoOjbq>_So=Zm0{wQ=LYMu z!wp*#U6Ma5@(r<-)P{pTRXzT6wDj1SQr^S%-zvje)dNG{%BGHgUt1(MUv{(8wM@(8 zsiy~c#93XsILu8iDMbnL!G<&NxAaooS|=+)nXmC$Cl&U@OXcM{dAK4@PUPz8p-PZy zUOL&VkCt_!mD6Uu)My?nt3Jd_kLK~xZ4>v)H}taZZmcZ0q?6B~dTDnkR+=y)BfpGR zCY+9!v6J-DDv<0pVx|M8TK~-ND zcr>6Mp-_)%WrVU3f7nAYF+SYrwh(=e|~tD3o7zHJ7a7^5(0N&R%&=57r!( zGuw~7<~Z)_OGAUP`K)4qXYJ6NeV(0qlpVx6&=F<2 zawZn@@2gqsdu@@)nJn^(>}&V;WZmX;1}+6K+u{K4=j>0PIL5!v;_Pf_IzES|V`$5! zl0Vl~MsI5_OPB#C|LjCjM=hi8sl@0yRRPueltHc-DN-kNefZYn5-d!xFehOUQQYA>Sno^s=x_1C9GetCjY}M{-qQc zzo|%C^*2k&_kZ%KLb0@}rhp~)NtZ$t2>N6eMVTV8IHJV7HA~^3D$% zdicTmYXHI=>5h5zpB{Yx4yOe`9q12ty+2yJ`(f}AUtC@4507sF=#=b_@t^!r;O~d1 z{{ArC@YxpY-@Wz)ZG{X|A+|G+!ldN-0zL%-gHY-x*Gq{&p0^(`>M0o{4xUb4+I;x79-NvwnC zu|}VKi>#D^_3(PB2)8%l))*t2&R{Ms8LXz4=#N`NW??LS4KGvC*`D0MT=G+kQ&CBk zipu=|wt?Ozn^dS*(%m?Yj<{1P7^$N(?k}^m8mA(kuVL_Kmi2bB2gg#-wmEx7J~{Nf z(W#i4je-1og>qRCi)_4_X+peHHg;6WM!9UxymmCfr)M_acFD#GPtL4;WhUWMGFRJK zZ;H*vy6>E49hHNj^O$kDDH|@ev$381@SWrZ&aTTr(h}xLKgq_W&2(?vpciRxHafB= zvxjxEMxEGm$jHXeN-CLLsFt1297XG(l5zWOnQQ1I!wvM7?qtoz-9dWYv6rKZ++^`u z2kCj!Nv0ig6xr-7TMOLeXhvf?7+oZ;u8R!m;3{)6U8Ve97pd0FQRa%DS5->P?ph)r>M9WZRe|0a z7C6dly#6ThY6jg}qC~K_0vmG`s7-(AjK<`C1I!Y;rdT|Km1yy$M6|V(*nUch zl&j<%&1RYHRU!e+OXU9je{y+63A2Lesu)lrX9g6@xT<87jS3_kE0Sgd6;QubVr*+> zg3{SoX@x%;&GW-$dQVO9%(=Y99J5M(m|7zMJ8Jl$M|ozLvDTH@+#kwT^lelnV==@Z z_DKOqeNSeQ*IgXHZ($!_*v9z5{X_tKK62*psxJlv`YWgt@_-`t@9AEe&#}(7BsE>rxSaQVtvyE*e z9>#>D)uRaf=}b1bJ~_uB^fFD2L8z2Mgj`}g9agm?k?qHPcdH%fJtQ0kGug#q z{Jy*}Jg>?b*|}tjKhVcDJ(9Cm%xGK3*XHjD#o@3BVJ7v_aJ1QD#2fbgCXS)s^a1;& zb9mkKBq!0B*O-B{e9aaejmWU3TT79O#z*=8&*61gGnMN*BO2!M8cQ@{;lWhQxoboR)(q#(GvW(> ze`g|7#Qs`Q&1|H$%E5#Lp68*g0|qmfeMC0qlNs4Ghu4yAHnxo7{BLg)GRYy1c}EVh zCEbe`v+%l74!jqTcS$nAYg9HG@_W5*kn2b%+xVQUaf=)*`jU+s{CfcTn7;pVkj<|P z$)OLjZZ_tvWZlS@{m%%HR8SG0&(r_}G+BR({YJcFOPz?^@M0Sh#ga{(a)KVUsa2VieZvPyp)=%mElFP@{?=9`oVg+H%l+u_cH%EjQ)wwak9}*Cv(rm$ zv8s^BIox9s<{2k*Iq%ZuE!T{nVx-Z(I7xBTi(`!hN&d+7BD1ebmT1K@H%9z!>R7u? zlsO~mW#lZ)ovZAPS!!kde62ifuaof(39{W%Cvek=vM#eOYjQofRt?|wE|~Ixy}TqB z1Z{Fb6K6Mc^r!EFJ+zA+WI|H8CLFIqZ>|Ab&7ni(sEW*u3##qr+HZpzI~us+K>&S9 zpV?m;@64=P6^1#h&@xOsIhznXJ%4V__~6bb6ktwTjYYY zVe}@FSxBf9g0e{(G=3j~g*Q0g(m;c}ln`uF)7kP=gBAR`Z{>1Pe-Lmzlku0OeUEav)h)jT@E?a9|{BfH|40aaiIYLYdq^eY{U3(^q8 zwc2v72YYr+M*-J@?;O*S(>?>nUYtv5nt{g4$tdklr#p=GuihEx_J-MIBRLbpzVGN- z{GFb!zfN?xkW)PBnu!CYGcj}``H!cp1v5v-df^vRnn~voe?~y@wF^b5NwuvoRLX>O-AmiFD6*{Le)6{2{!_eKZbtc3%+Q< z=g-+2^z$}jCZ@{{wx0q|M>P8&odML3rM? za{ry3Y;Mp}G+aknY_^sCMG9v0l*nf~z^vPuW$s`F?$=dfQ#JBK(e$;=;GD&k0Q}h& zfJwXj(RFqNHn=l$`W%^=nUQeKjD(jL^QPCP!orK|)BCBou`m_evuKq5%J~9+GW>gU zkn54d*|!|lhIlSF&B2GcNfOXAUaVFnl9SQPp?i8sUKlSsuBp*_mpc|#XC~$c71BGn zq5=2&k>ly3)rX?+FZaHI8r&YM0p@6M>LvM$Ejk<=$a|ME9yiXA#o#^3_ES1$f9Gsl z5%-;DX3ccSL^AIS`$zMDis`RWwH&O!=GbglkB5r5R!#-Z> zRMg2rgBmLbF(WgB9w#2#2tFtB_q*aX^F6$yLa^*BS&)~Zxbc8|dN_SfE4k0!uEQ87 zW;*ZUJ&${5LrdlrY+$~?R{COjkGgD`i91Od%zq}E&D=-aPiaC}89^8Bm2{l0 zn2GTYN>3|yrRSlkNrT=CGv z8PT_{(64pFbw^iJT;z(JJhCbE$?NesR*TQB7onk;P-i*Db>l4LbUl*8br{)`PG7Ph zAHDSSosm&rLWhI{@9}-f%Y^ct-Zc})$%3pr#XQqkg=fk*g=ddU@~0;Ht*XUK{AHck zjv=SAHBsiRh?n}z$Xr><70u`;ux~;?^I~Rj+*f1kWHknC*PvzDP^^xjHY|Ykg*JNRC=~hlEvrzSkP!ksU7MdrzWcu&xi8O?nNUBh#C&=q@$xe6ya$HzT*@ojp1 zE7Fa)hkNa)2pmi2-gN<)G|m}~j@U6gEuG;>1v|tD- zZ45wEJ04Sj4<0V$J+OfL^p%mU=|-@=Mi=~8@^USVcw3u(z1w`Q?oP$XAx3QdoPw*) zIe6VG2P3=WpuvM2G<3{`GuQLm46b5q?Ji?Ry2*sf&7^FSyV!hfCYze_nI2y( z?TQj3S8-oAPl?YJ{7|7<0Ls4bL-nu#v|Hte1JC{N*e-(mD$Y&TC*#Sw!J__=7^sNE zVguPu?%zA@;|vz}^Z3WTgqpk_*ZZgV9No>ma%avpW&7k}A@|suSGY*qip|8z+gVEa zI*FmMsXUBxl8s&YUQ{y6_znvEVA$`f4d%cXnVm>b_4Twa|%4FVmq#`?xb7IfAml~alf@?-ZS~G*eCI=Ham-W0w zHl{Dg#gR5S*g@trHpoHjtz0GWv09$}a+Mg?z`C8~IpaVcwVd;q^q%*vuj113suwY|0DvZUqs*<_j-dhMkKH2XS6C6Z~ic& zlMZH_OvUxXWM6ZchnUa#u)4W;Xvul8pV{;$xk+9{cR8NpBvbR9rIoIkOz-R>%g0)v z+CR>7@cF*dS4lUf5^r-$q-HU_PcQvZi_g_W1!r;LkF)Fjklvr4R|IED?7046{io}& z9SB|)iTh5S}>3OD|2kMG&IbtngAJaf?a4L!`9;hbJMQQ94( zt2SRRgMH)4Pmy7s!@TJ%7i0yvq3k$UXt#2{K0=KO-^ep2Xi%>U=hL6@xxu-j($je# znxNsVln$3WlVAM9b#)D{$=k&LcYW?MDif|Z)9FXb!1u3YzmAecd(S*$a@`;5DLh}+ zR(h_TtnfTXpYBoejBke@lRs|~CFRml`Qgqw`i}&;K)zDK)fjct4gY4Uv3Qj$c3QY% z{b(mNvcLqjI z;Y`r%4BXG9-J^^P$m$KCBeqLr@`L2{j&|W}z$Be$dXd?C5+@GlV&!xh z&Ma)B`*1YxgGoFV*5}9Cs!`nD6^5a~xMQQiyZOv6_Sc{dpQmsAf-#S*d#3~Req7R{ zm5(0Tig@%^=$U($jzAt$6RzW{*UH3_A|BgqW-BkD+nCR<*$3&Yg9_E9WIVV7_ab+3iPFFc9P04$1@QRm>i*#~h8)rMnd*-cj!F4|u{JrNw4nc+Y z`{>p*xc=9@e<*-i)1KTDmSxUUP$-`D2t~;qJuXgQ|J6dL9ZN9>D5q-yJ_mdyw^F5yP6L-nR&fUd6PMKHOgdd$Q=sKMk&x*3Bt=v<3lg$<#Y#I?t}o%DN7 z*5fhf147nv-NDc8(sw;JEX}}x(iw2sL-)WU=5g~gE15}mKKafTDezs!dP`(O zIq)e@f}i*x>L}-Azoej50~56Ct?8F7mLtFEU%L{Hb^Yn*>YWA4GPZJndBiKqu{Pa~ zIkw~(olem!H=>c;QT~&y+c;;`oqof^o&8$Q`?G`td<{+=})0aw(YOLH==C zLuoVmpL|>4gFgqDFYLhMbjw0qww+Y5`6op~eDHi@7?u>KAY`WrNx$vn{iq^&*4Y<- zdUM{n1O0A`nIC<%k<1Rv7t4;!Y31?M48&4DPrHVnJ?`N~n|R@ZTqsr2rJo$^DK zMf@DAle=W?y3~tWvd_6#$~^PI9`*oYELnFH{=1Eh_!|Do-FiN7?G=usI;r@2$OMO# z^`!I7V(Hh@2lnO2XU$5+yJug}O>ZscumWm;e9*ZOy=*6vVOP$CP3-$j?fF-N$&;?W z6ONxeuX1;okoCz~cDntOpziE}%nQetYnDANYAkz~{B%;1Asy8Mt7M6k^cFa%8 zvKMbR1MY z^MN{&^R>#xi^3*Sz2QH}@8g5NtWlr4mW%*$ou39bl*nFr(#hT%{?+NexJ90k9Ad0@ zJ+a?k$O?fEB6xo&Q^N?4FIgxv!b*b5B*>ZEeog4TFc8O|74gG|6RlUF!G62qD^?c zsgbx(%9pl(2I244aO^DR>(}J@@W5Ka))YxDz1vTFhQl^C1xU}r!JGCH!k)u~k*wo4 z;Q1Dwf~u^AthK8zn^lD}>YNXPVwrQ{L@(zw6GvyPWbC0LDfA%MxtsR^XCsDrGtVo# zfh=bJ_-BPL%;fJHH>0o9ota+m8p`6udD8rk7j~5nL)G{cOl?4?#YXmLJb0h%<%6qp zcs_?GKtH3W zwUjIG#uu?$=Ghn!hyLe*}9gW<4JOe{O|gBGzC*KvoP7&mbrTW#OaDJwv-J= za69I_k2m4PR$HkQSS;!)%ozDa|K{mrJl$);aE-NWdRinWCVDeJl|B{TXXfa#u-y3& z8Ea>Jm>h)OtF*WhoQ5s7^!xvb6_*o^*d0agiG0wF8;{YwANixQhegZz`i;vqIBlgR z*OP{`P0UdJJ1Bos9DxZTjOW$C?Qj|{H#Ea;?-2=YQ3 z<^>1t3&D72-G6(BP&kN7%GPLm(>RAV>urr&MRVqTXtoL@!1;iJPcZlV*s z6&kcBdoaQ;4Nf*@+*uVZDW9Ftl=9oA|z|ne!3IT8%SjgTI=Qq&XsAl2q8ee;Kr^ zwWwRjyze&5vkr`vo6nswkNM6XGqsp~iMixW6rNN6MoVie=AoAaqsuTY-u+8MbajQN zGxN9ZxbpL=5)9WqI=DCB@dVO$X^NIti=*9aO zrAC!D^gNPh^q#>Sd5sy(?tRw$Br$UT$cXER9JUQiAI_$DZ z!_;&hCwaghT^+EKykXPPIyB0sM|HB9p2cX%>*0v+0pt+L^Y)*ghB~v%uv{J`7u;3Y zKQ0($ZqnPhm9Hb5eVrIhhKv2Gjv?4z7>CVP%)z?O>(us;6jWAW!hm2X`Tl&m`xuVo zf}6aLmN^+tnDvyIBF{OqU4zU{mKk>qQL^|7J)sAKu_Tbb#VO=i1I*CxWiE3cXH4aF z-FG=>^c>P*m{Eexn+{5ehCR1n=BI~f@q+*U!HYA~$|IuTEc-bg=S#j11H$-z=9+OJ z{je0pI^t492;T5KEHf(&vr3!MVCWIC{Y-x%_l^EbwP=4a9kr*@8@nS$TojI&_jW1X z(JyIYkI0kre`(}cCp~e3#nmAEs!pfJbiNKf_4W^9#C0F%4*f8ziv&QI&CxWWAo`<8^)Y&V~i~4c~yTGb91|B z@n$f+wD;*(T^=hRwm2j9{4z|@&=YD*M`@n770D-#uvDWUY#A=|{<&%zulL3Z&%TI} z#f_X{J0%!9|7yu?q@gwW?v0DI@~(k17V>zk)3k6{#_N>Nk(A9bVp`~gR}X^d;i9kh zPC7EFJ3j) z8C#YtLofF4%ma8mR{o!TSTlt}5wqt?e9wROaN5P)lK1Cc zGjv{h-=pU7)rOMKjSOdZ95Jj`zq>d#{dA|GZ5<4I6rVaAI#$ilZBbLhyg}Tf9BaGl}P_2UMss&5V6OCK0I zEG(bgyj>TAdF)Yxp+WM+?wd||n5J*_SXcSC!S{H@qs{CY zkB=AYa`93H9ra9HwjK`%|41^of-zD|9kY6(@^_>E&*vcvBzG#O_ER}Yt!k>iSDdI>N*$9;=RnNfg4iy(wo?gbA%IIP=1w~Go0*4$B=tu zZ~0nldU--zFq^z;U0Zkb?W;zhP6cyAHJX}L%&TS3ySJM4e)cQsy2AOA3${RoE_5>N zDt5v5KWaGrR>6{c`OfcD2A8`%F&48iN15DbdYpi?M&%$MoZ znWDq(08!rQ`Cr}({Q2iRcO7#~^%xPxETdCeG+)HE0{hp|*L4V*z~1y)Ju?Hy zJKv-ypbG!oo=#*wr^EW_Q6p7{>U^!4zd7d+M<*|zLygMmurY#p)W7)}HQ6U;4|{P7 z9cH}IVRj=O=AL40=R`W<$Sz(VoDLy}7{*%98xy(3({wem$K=DB)bk(dnDLoD20mv` z#bwa3myQ6|%Pxd)_LdB!eR=kxYG&X(S;x(+6KVK-o%|&Y@%uB-Yb-M?Ea<;z%ieVl z&h0i}?SDA?)@w81&ga!3_Q3<&rsJ(+23i;#_@8nVzury~Y40L8Pd1i`O0_s!I?Bw7cG9B-b9XZArKPn>4ll761-Zq{^>$+Y z*-1{ncaZ|-DMh|yrnCncteK7Fh^?J$YtU3u);Y+WCr)z8&0Sh8aF}3DzmU5++ zStgfPVwY=)3_hTM_3C1o`&5Akp$f#*Q=m;ukqj!QfHUj1F1JeLO-t^$QWWsL!Cc$} zN-R?riE(PN#E_vXiBcjinQQq`%+4i4)uoOSks5Mboy`)whkm)iWU)T59=)$bI^|fP z%}FJm{P`zQYt3RPE|kCC%-C(`2dnmeu({!f=oD{ktn7z^SANVuVCGY_A2Vjzt9M`> zf4eX4exy60p+DXP(*YDtkDSRH&j0+eV^RR(%dsEvmfnCbzIfNfAA@szu!YRloqXm< z5AZ{+IsOQDp)+WdAL6b3&|VRM)v12?Kct=YTa;@Twr8-ry9mhv!9cePx-RT((O`?Z z?b_UsF*AVO#9(((b{7nGQ8M54zVGoJ-yiV(;Gx@%ILG<7`h2M$L`JY0fh4W*xjESt^N%#_jYd1fPpSTTR8V-pi`f9l%{j&Di{-uxTkakbYpFMF|!{R@YhGl zHm-`o(rCII$!=Y_OI~sUIW7L(%?FU%;{QMLnmj^3`WGXaWqX~uP0KQ|y;c^QJ~m(w z`zVuUWYOB^=*T}`ISc2#3^>l7Fn8E^Vr78Yu}pl@XTs%uCQ3>&abh5OtebT2e`J53 ztdnjzbG7`)8dhV!q@xkT)*5k;J&KhZicmbah~6l=7j<+lRxzU6R3k3!V2>b)oD_d= zR!2H3YS01YV}yZ!ZamM&3Z6YRujr6_K;Ei_kv#`yJI*e|zAJ@@9Y&^M4!sV|*~>SO zm9#8E|9VE$sW4*b1#8L3P)T-qN0~g|R*LpHNYP{V(hoVvszY>4y|nx0G>von^pGJ1HIDEK9%H%lu(h(p<&f%6HzU8`_Kcb_bd5 zsuH_;tmX0hbR9ysYGXUGDpSdla9gQlY%hNu=`3H9UF5z|fw2R~A97}UcMI|ram;kT zr9kh4CK)%#B%``kh|01;9`YWmGQ}jD`Y9lJ72>~*eVV59Pt0In>mRZZbQVph^IOi% zS7Jte)|Yyg%2j4p9;;!7^|eegZ&bNh2apk-qJ-5!1&RilVVRu*6V6n~!Rckv_>@W7 zdomY`_r-A?-CZku5$@=Vh_1}SV&CxURAxDL^F@bE%yzuM-dP)ej9cf26=ebFH;&$o z1%7zhAOPzQ`{Vi^e?0l>i%JXpaqGP|rtM&E^(0^P7(;*KS05}Z@x_I5AAH#yfQ!tH zdvwwdYBlfO!@fvs=!+>D_L+J!d)kj~)HBhTZLdL~TCDjrEzs)+w5dv6Aj5Vmf$D)wKd-LpDI#tJI;cu@@^lL}Y zQ!nzsi^(z`priC3x=ne{I5ptC*B}drCm3+sE|Z=e1D=g#)=gp-y|T<;&oE#cYeGla ztGl;`zvo2OV=CF0ZoKD=2E01V`Pu=Q2%19o7{7Ki>sCEqWMcLX11^51pRq+2RJjJM z2{a(hHw*igF_R+Ni0$uqKYcMG$g2podEKv@Z^Vp!22Wb;Ua+Bmdb1<>>7KfM>4P)RqzAT3NuXL-Ctun4|KbKy8>tF6ui|4sD zv)Y?JDbOZ;+s&)#H!rQ|+3Itq`}YE^=&vNn(mF{pa7&WVl_l?(H+_#jr`*tF>6xyR z8RqnG5pI;l3AzNgNd(c2g=7e>TOBALY3`ssOp=43>&$zZomD?`tMZp2PDje{j zAH7u*9r3cW3R!bi=sdt4J&X>l%{ky1dyLaKzt=;p!uvoKIvlXa&BJzl#yY^7=bI&k z_E@#k9$u#%(3yKf?^`PPS+d8}(h;toIY+}Y%G`wxxcN~9AMPb@mN=r$Wad({|6|e9 z9!H+AhINelMb;Je%}^tQ^^t#?g+ozDCh<);>Q7fAeTf?He{yff{h?f_WT~}@QVAv(m6aQm9RHi#Mzj}oTEwBqxbb(9Ogc4*rr^1 zD%i7akdN(N%!01PJs$US{U+1f=#-D#^SLi++1}(slegp27a};|%kr)nBcoaDcsZ16;n7 zv7V3xd+raSI0F$egFZWJ@_J@P7|C_~aHS7uHM|ftv+ZTB%1M&1JIS8&R>$N1bI^Vj=h!$Uv(cH>-0b7oJcYEU+j?6_Wo zCI>W#yTs@Ca1EAyFhJj)j*zc>UY^K8JMLx1)L^aI!-$79$#G}W)jWf2^-elF{-s~9 zGFirW<~h@&9DRTsV=sH@=hjhbL?{tnL6(1;5`GFZymkI9KPD)!MN0Vh2Af6DbCFTaebg4*3Jz;Vh4X%?$SUe zGIM%Axs(_5Ta_{cjcaOi&dn57&%!n`_=CxWc}$??!j}w#d#b zyFpGqoDAb;7rE1?lh~O$N=b}^d|qQI)(yKkBrhU@4j z0}{BWT>adLA+w6`sn-W|oNYvWRw0&5Vx9I6t=Kox%Bb>GIY%C?&@ojWzo5@9+!6PA zws-KPmx!GB@qG@s(>wx?ZbzU;f*Mh!JS+F*b8;Ykgd6EdIzgt^?oub(VY2v&*$!9 z`YZkNaQ{AQeDpSrj#YScD>uPitMF)6M%I#kEvMlJB_l{D=9?1aJz0=OT+jOsbVS{? zoCmdWf^%<2465aXR_2aSjg5fqOFD))U_{rJp1p0xiC&QZS%Ddil zU6qhQeM$e|1#<1DStn?fhnE5Q$R0taaV^;$`kMYUC_LWqeOgS`p{P{hF)}Y%(zhIv z!WIW*9_JvA(%U={0o6GM`5@QohNn*5K4t-{aj*zr6}@0yQ#O<99TQ+R~VR(SLw zPh`XQMg5kpjdt`91f@uud@?i4CGi_iH+5#JSgq4a`eyD&4zRxD$Nj@7vLN^E@$0S= zYOdoP?B)pc%Z7M`6lVCHoLau*n2#olmGK0S!Nd4}vp2CS(O8#xbWnWB=Z zwe01G$ypAJ?j%Rz97N^ZMdl4s;88UNRy?YZsyusTve$Wm9+irV{>bVPh-AwEe0myy ziA(+PM<$(rz3FAFM2~NU21=esKI_TJ?I9mA$$*wavv7-N=Ol82h8N7i*8GRpBM-OC zh)TzpAxAFFelqv*VSH^{Tx39qN`ev{#G$vHh#v-3^2Ics(?0O^= zAIyTkodIR8TsH=>J}`#o^T|aRJ(#cKg%LZi(anC;2=lT|(qnKJ2|sTuB|-ems;H#> z8(Z1(j@ilmmCRf-VL<)6`*!oAPW_t7vXGuYuTy7!l6;WTR~sv2ZHwONSe zUZe9a{)jHZ*ZD;#Ty2Ca&s_nVI!eFk&ddYqC?hBLkU<@7CD2+W-JO-V;Y{x`vpTnM z&ahyd8SZlCBz*>F11FEb%ARCm#|7f-5zgff2*AJd==c1f!Szbp@Tdo~1x!4PR*S~b za?S^Ey|TE?y3L3zcn-_LZMrOvq_Xz0sR+;8aVE`&c^6#YgZ%k3&p8dw=;gP+PTacc zWY7=2+_g%PCjU6%_EHC^|8PX7b1Lj!uEIyI8?Kktcv532!q2GbC1m~%pVx>`!#!IE zw}r{5dng%lNRLT7`3#!FS#j=#1Jrq#b0!zb%kwa16TRY_$>x*$>PUXM>j2*GYOY<2 z{>SE5HtD3-GaV=8b@C!XFI8%?p6;cW8OJye@F(+yxPHx_rNX@}4ro=O!Y9`V&d{nM zqarY#YuMw-;p7L@2)fHG9`56p^R>82G8S&cM<1E((t+;aoGw?|q;ncF?6H*+$o~)yyN(W<`<=E=ZCMyHn&*kP7-8Dpasm ze_caLt=JzDS_Z{c1dU8$e zoQuAr$eCB+GjSMM%LS|%KVls?j_WA7%KLm@-W_AVmh7P8MTN(W0jUybmnz2w>!riq zB(bf~$w|kfq8O*bD+fmmuHp!T-VVVV9WeD1^OsgKXZk_}A}-Psz|U$=ANJuh)Y!UG zkLGtc-_LW-nIUu`a{n=XtsYx>e%Kw6hv&QVk;XMXKZvzwKb|SF>4xO{@$sC(!;D;h z*A)tn+GHC;>3bOWAVo&>Wq!d-o%~p-lO2Xs$yn`(GqW6V@fCU4ZYs>UtHSqw9k3@d zg3lMO?X@CsD~VhquO~Iv*OpvMmj`kU>y(VC<8|mXifjC7_Wdex9eu*tiEjCLnU#nA zQ}Zz3GdcK!TrbGLE22;kpWq zxhI=^M}?T?DwHo(!KIQ4_C67K{F6?Gugs?USB?2w)rdI6_h&QrJvrnC^0|(#)gk`3 z9-Y`9Q}L`-YeydQ=<{%O2{XBMdFXwKndM|X9nL5`ws|N$4t?W{$ylymRsJ8(m}T8c zS};fGZarUI8Ar}&K6$hqg;;vbLXzhGkm+xI5#W z66-6a@_xQI29q0FQ!f({Im{7W)Kc^XrQ$=MS3dbN-8FjX+S8Lb-$J%dDVMtIy%3ug zg@#`;@No@msApQsm|JBsafBBfS?79OmAN0g3UH@!OR3Hr=ZWMiOZa_)gEE-WSjhFo zQa%L)*xvlL&OVmY;te!vrvSQ(swKm3@Hli5^q`;|zQ8$Osj zBN7Tj2C7#SAls*@T%t#8buVw2H=rLdArr63*G%qEPjZ-VYZL2@WuxeMBv+Mlv=IGP zw~@r=3cNLVq3~%W!rx~wud@K}uC|gp8%pI+H*XwBq=znub!zuQ6dr3PB?n5R9=(uD z9a&GW&stnS0S4$IQ`gc7wc|p#Vd*yXR(ta@v9N*bdL1pHEkw&Crc!ieTS2*<$p{eA9tq!1^rveQ>$`0JCN($ z4*CjN1Dx}z0Aq66$d$66GW<_31Rab-_NGh>dBR-XKN^aE^)m4u?uWsZn9bx)P7~xn z!`n!=s=wr)Jo?}kM8V0EoZV`^{(a5m#iUC<~Itk zB(;TX>R2p|&B>8nBd_-@6YsXLuHLP+sQfBqUzsmPwqf4QI@bMXk|WD$C13dZ*Ix02 zF*p)$w$Z;ilb*P$Ev0lG=j9VUaW#G`?(AU>`1k_+IN3r5HR9_Th55`Vz)vJd~7AX=M+oxAKsX27Kw_*L5zn3%Xf7=ye*0i?L;Y+djeelBJRh(Cx#(mnS_i)NLmmWjP z%6Z1^FDOGKt7i>^%Qr`K&BSp@cUMB;)F?dPb3Fj%6xF%*M)rwp>j2ssLd7P zN-kU3klyHp8F-XbfKfNvNzSBF(bJoGZAlbX6=%TyN&(E9v=nWl64^)I`9SL^*2Xii z+?oF_=T_24!RJ5?A9$^e!i10HQWH2|xum(IWR~zON#7{@VgEXFb|j4a^1#-zc~6;y zv2XA*Fbcgo^M2=Z(si(yX!eoQX{n3i0TXx$It6 zCfbJNh&M#iyP1if9}976a9g>1uUO(9d1FfMRxCY}ftj1h?b6R!_^?dY)aLci>sgRN?a{^c1t_qS#Y>oq?Q?0<=<^%fRNpot!TYjR$HuVS9*7|z6V0&AHgm~Try<#IP01T_o8wwjzh*_eY6awt1L$4L4t zTO2z|{~GxqtBM>1rdMEW|9F{0er@d3a10}N){K4h!{inZM<+<|T5CLf8UpOqBBpjO z?!=Hwnh`HH4d~-LNpD>ibEqqG&hI3>jW+RecROn%uS2kTEWLrB$&t-5;rp8y*&btq z8I42nrl$_Q>oDgxiT=1&39|034GLR_!nUCf5f%4PzZw0Kf0D-}r*oLEKeD41QR}mD zqbIq=AMvuRGxLsvLNU3C7BfP~<0R1McrjK!kbj&~D-^*XpLL$I?vv>stQjX~$Z5Q~ z9EyW{Kg$~A;#yx5jE4_M-wF2U6BmL(F7Xs`YRlJ^0n}LmV@q~5Ah56R%csmAs04#FmslQGY-;6n% zjTz+fu0D;I+!uE6=XHBDREti%Ifqr1KDeC;(t&aW*b;X7~BjI2n4> z7TME6;7ktXp-b+6{f1vW;w3G>7Du*+F$-IZTg!9!Of+HXxL66NcXHYJ5LDlxMMf*; zHPhc0G4+5f*=LKcrzISd{2Z4Zh?RtLJ9ymU{eD`DNtrpQF`7QmA8~StzQ3=$P7YqsGOvR7 zos$W_4a|d{Y7KeKTx*6d3#iw5sEdv$eHFc7oPV~yEXfyR~vgc z_UHY=zqiYr9Q;v9;h`BBFMIdf;`tQLf*<1hwmS!VzMC-9Cqc%OpS4X0L(G~am|y1S z=nC04cuGe0+jd?u$xxAJ4 zLh$g74rhku;9U;=o)&R3X{0^kl9*Rco^*&)4hFhbpx&YV(tHbfTcIcME3cC`*_gK1 z#0FO;@hclO$&=>Jq;L0?Ju*Lsp~RKG%cI#i>2AV) zz7K2X+M|kj7}k_%agUs7SB(i%_8gG5E9`J^Whm&UxsH;Pg3;SWN^lU2QC3*^H)0T$Ov7tq;=o}3By8>>F z;v`?}p`H?kx%~aSy15wGvEsk|u>T*P(c<};^l5|B-Qo`)bThuTOWPTv>NRBC#`KRp z%`^1Xj=QhA*~BfP`JQx}YJ1bGh3!xGS#&);NHyW8{h)>Ftf?rNK{V918E zsR^sn7hK)sz9zC|uVq=SGA#A)+&;Fvopx4l>%J#wP0#a{|4Os0wl1x5-jTB@ar*Rw z8~okJt{9nqH)-3M{wvbclU)z@G_BT3N;>PsXA@-(^9SB6N)(S%DKdR#io~_o$>{1y zVzE#sBex~Wy1Ge{Gllb*8m&0aN|J6{lVsT7B(eE?Kt^XJ%GvJ8ay%eKPXE$M7iKwi zeUu;zb|uM!I?3FFCrj5hT3N?B`LUFEW`8p`V@-o+|85aX@uj_C!`Y;8BhWSGe9Sqfg*> z0<%Dl+2ip|&W83P)2LSAMQ6_Pv!1bUDA{3y0}_5aA|qafltC)=D{w%@IA)Poc0iwS z2TbYci0btnVex=}N7D%O)Za6*`sPWgYFbqtI zfd6Rv8z-otyP(F5kMuMqhNB1neCJR#n!P8l$bHWo_9eQ!Qe*P1aC{F^W6Bj~m2kb8 zJ(wATtJK)T`uB9!=G_-Ee_{vw7Oejq_*0GNtS784WbY!9`O)b*Jj)>$eO-rTnL4cV zq_cwecW2f;URTf`JX(hk{v5eqkH$vUt4^?n??{g$>or~Yb*nime6<5T1wP3*&K}6+ z1N=JwWYlE6q|-Bg-;R3xn@iUNzxSlcdd|M-P`zg|itdqXd`%C}LmkTJ@wGgq51M^| zCwAWFz$_)cG*Q4JPXQMwaqXQ+w9kKw;YF#aJkZ( z2_?QQH_6~yl{lxVgnu?`^VO87^n?zWbR}-?WdGo6g&b?3M1z^EN$;kQpt=%Gd(n~b zf&K7-{_tggcSKkqaNG}#elnx*5&6YNzSz0V4~J8kso0UTj*tCN;Nu5Z71_o0zKBtf zZ*-?$#*Dc~nLe*q&JTB``>1CB&2Atqn-vQ{K!i+q{nfn25npL_imA^I!fkhfCil#^8YWQ z$G}{J%VeokTQxYTivBNikoSn3B>&EC6PP`?A)0$7GLHe#m~euOm74CEG4#1@ARooL ziDDRes^$iyHQ+oyd&(XDbC#cHK)f$&X$8#TtDS{=^danKy?nth16BrP!TT+JKZ~;P zl#JHvSy||Dg!S~1S(sp*g*+!mS>A z1W}x0Ja5DjM>+`T@zJ*^!jtAk*xWKA@<}1io~GOJR3UnHGh#Wv$Bjtl?iLvlLw@ma zMj^KEF=7M1$G+QSw%DhUkwzr4hrcDpUe=y=5;O7+s}4F!%P1$Y*kmh1^v?3R3VFj0 zR-(UeBO7GNbKDU;M z1@>Z>>L|_WXxwbkLH>AZBS}M4@~W4OM6~K4%9b6Z(V_P8YmQ1T9(IyLN##y#LYzu}%N@E-1Hu$2y;>m--4*CF zfzF~+be~3;WXS_^8kyy?V?R9*n@zH{A!mZy(Xli{fgMpwSezs0QoUSyd67fjOcxaI zuOAx~=#@rpIoJ%{Ci!7HbGWvU>z&t+Ua0T@bX!4=qOw2s_3%gW>HyfkWtN!I4^>&C zG^W$Tae_SJEMH{(K^Mn9Us#_Cz=#!oNIm0+w?F-0-Iw2^x*vYFW}eoXKn!O-^*_9) zrsevfRu_Nf+4&)(W&qw*XWl!1&-m4!E**dL<@b*0%KNL3jKZxbtPN$)(u{0kPYuGp zN7G%Wfx~WQqn1RWnJF4x?eb=f<4AxbfEIj zt$j&mCqjcIuJo$j;XTKn7n6O+$cx6g_tDs;AUD}SgLCd0l(f`f;CE(x1ZlAQ8r@eF z%oqtYVAaF_WKkHHw?HQ;xnI}&beZ+ef^s5RUmf#R!ZPVd;r-=jU_Lb&;DrX%xypJU zzxF-vL7xYlL7rv6xw!wiO+7URys1gAX|Mq!i`if7&i`kY#hMCp;e>V6_T(?v>zgn& z3p1bbp5%QUXf!gj(TFjAMX+@$Lf5WESjy}D&Gkauo<>%r8?%haXDn-P#LM@EXl}`S zi5$|a3G_J5=DqltGpwvz{e7Uh1dwa0+^7gK{QD=D@cy!AFEp=FdU~O*=ZvlE(!Fl4NdKiubc+l-mF^a0 zm#)}dE92;aSLx*u$?3<9zthV$Lr+JsyeAvBSlob66HC6y`q&)7Od1tzo-=1uvsUG zkF-*wp;q=rrpoS4NfP!?l6ap?mSq)M=09-`t-4k=WoqT)Z~D3llErPiR@}Gg#Zi+W zVPqc%{iBx_+frl==VYEKb<$u7(OiYrrd#RU^WC?=z+GD{{d+hjW zj{qMPO8%f%+m3dYZz>egAvMz35v$**u;wKF-4E;#y_aXS>g>;qvS&}h0R>_7I?iyw zkP#}FLjRL_%Gtb$PAD~U-*{4mmL(3D)5sCmrqlKPT7}$n2c&Fw#KeEu6*<9q%qR9( zTjYS=TO7$|sW8|>jV8w;aNV4HGjfIxKZL{n5PLwo)d-GOVM}Ll?Lh7xexk_iioOgZfK{J^jf%^7qE5$>~(+@cfA$2ihj1=TRM$tY=t;>F}cpvqQOW zJa&=U(^d3%%C9?fiW$}|nLmA%-tR;`>Llt=*_!=Y{{7eZwMzE6#@Oo-xs`iAr(EWw z@Z8V6;I!wtsQo$@Gn&)2UBsCd_Hogi^Du*Q!3P>HIWQ;nS}yXwat@{e`*r8&R!rbb z?4Rt{jm*W!K6!Mdkx@LxzS%$YR}IKT)3%%~Wl!(?C^{Ms<)M`#5B1(N$2ubygEGlM z@(e!wIvs9P{vXd+Mi$QJcnA6P7x#fTo#jlblbjl6BL%)@SW|^8h`ADHdnu4nti(Dy zC9{9HUwP~g&pbc)f1w*8oIb)+fiTObTe>(JE5qs4tF;Zwi}>rEWEvYY8~9Kbsw8J2 zzmow2%*ljw$U?U21L_ScLRyRw$2^MgGWY{r_b_|0uS)I)+DiAA^b^NA%ds0ya&CZ= zyl8KR@iWNJx32_?MP}$UjdLtlD&$wy0JPKlfem-m&i04n;XrJmlOx%hzUnXBPbs5e z@67!W+49cZH%;1RK!3|DeBmC&a(fn9+#}2QE)yR&(fjN}W{*rrtwiQKzbrysvIZ-Q zRPs>QLC()|lmW%I;_;a-e-h{f4$vT6u?=4$_^ck!XZ;Uy>wG5f<@5bm6rI;w zIX^*We9?p=Sl=*WA!jjiFVRbFYbURIJB!P|9c9B3l{8tek_WkTH+%B$fAd?u%~qoO zCMDvRD{*gKg$(LL4;h`6oelnYZQ+l{+?TehABc(kY}!oRhQ2GANBNj}NQ>!0yb+Cy zTu-XUW+CLR0pk-m!$M}}papph@-mmY7h%E|KD+sx&doQ%u743$P39gY+*$fvaFFAj zne#k_udA=4jOMjcbGu1Sk!c*fS&7$2&0x=KsRv)jn`Qo3;ulD_IOh@4{BX`b5Q~GN zk;u<0$RZk!adaK;j)r=+22&n#jpABXZ+I4t-pRzB6a%I<%7W{9ax$06rg(FmNiuTg zjk(;#TvJ-P@Z94fVIRpAC2-$VrK2R7yU3|zC0xifzJB_fXL<$vHkrZqk^<*mkv%=+ zha3sS^lSw!F{4%BKM#@lBK>%FXK3WetgnFiFl-wfcyNtj!vjoIB}8Ec+>CoR+=sEr=l zM|p^T!t-PGeB9;vvX0k%+~PA~$oj`+6>BZx;P8w$D z#&T&Es4`9=+78Q4Uag#NFatJsG)u zTiMGeZ{Wl%$o6Kb@^7CMS+!4}$@Bh9vU#jId-5FJ<}lx@ ze>n^IK93GM@(s+pUeDJNepBJ0pqrp6U)LUfUQ@>Dq`zm1SOn_D+&e{1&eKY7|uM*E=y6DujACF|J3HfF!TU@nv#s^6ZG`!>#_Zl4qKb* zAzTyIWpK_hlkKryUF~JSq_{(U|ouP5ex1^lph?> z^$1y%NfB_ih``@n)G+rVFGEITQ9nJ7-`8VL3i&1l*X75|P*>_Pi|@yMer7)x(aU&^ zF5y2pS6w$Bns;9M`IBss~nan792>?|jT zk~iO|MC=a*)MX~g@mC^xsRE8$n5S^e4|!Uixu=qko6DSpXZ{%0n~dHv4e~2#@T;x{ zb?0%m&zcFMDPC>BhGVA8`_Z1LjKz2S0~X0 zSxYZJ2N}?$lPvY=B#k$!Sjjab@fgqIA2R9kqO0Aa2tC@; z&qyB4$CB%ou?VY&7NNI)2eF9jEGgGJh+RYG0#xcCetbTDBP)2N1z!hiA_XZ5oGN6U z#ZrN(JgfQmaDD$b0P8!`Wmzi#Q@Gyy@!a!ZEYC!&AG~(=Ip8vU~DtSgZSL`Is zGM!{uRR?;YoaFDHPI9=LO0q6h$jH_TOnj_B)0gBJ+bYm+iAlcZV++K?Sghukr`_l*G3h2&0;EOFaGzeC1!)2az4}8_&c~cDxvw7Cd;yEyl z{Ng~?aJU!R-Gnul>Ri(@IETjdE1BoNX?$%PcaqHwF2ejl2gPY(vRu_ANt1^M<#mlz z@nt?yPj3fw*-nog=iXxy?BTyig&x<)rFpPlcwLQuYcl8l4cCe3YR<)}5!*W%Q)VUO zW_vxVUeu$_U_EyH!`Yz~`S|^J9@dS^$L$4qSnwqeiDr2)dr7XF&zzX63XkW`^a{UF zc$~eh@R+RU^LaC8#CSfs8?Tp@ti{i7d{B1t`LidOe)_IX2#zC9UDpXOhdN@P4IRGy z>4>}>j-@Nr`0<|4X6Fb@c*S}5_w@PX>oCBRvjJyx2r%g2v7gVKF7zLs%EKqtavKKb zL34e=_;iQsnnLC#=v0*GZ_yx(( z*pl(Sk&DH#TqjC%(XSdgc+Nq2*3LtJx+-n>TJHAa^SOo6L;sWP-ZO+#@`9@kg#+1y=^FBh1DG=Oejo@1tLC*K*Ik0Hlcqdu93O1ty0l+WV>t+}43 zDm?0wV@xaJtO7qj?J=!XFu!2y{RDCNMo&XTs_a^l-JMr4#`ECBTJZ##KheOI$#zad{X$nXcobJm1w}=HUHY&W`3GX{OTS*f#o8BI&H6+tZG(X%RoO|2tQ9 z-m{fFv?h16*9W@q}H#oLrwniV`wI>2a}8OHW$UtUvj<^bBY&7p~E9`YFY1* zw2wU9;9_}xeK;14kHVt*oU0-iliItD^k%;89_A)rPKd;VXBjxWuMkm%ZKTdblVlHP zPIN^iToeX4&nU#8ZPs$nuS9$(Ey$q8e~G_%N!numU1q=RQfmf0!Bn(R&hE; zmc*Mn%7qve%v{~#U-F#)t}y<)EE?0l#;^b3+fpj}m&vJ? z%#E!b2{V5Ei?~8mYSC8uH7S$SZoXLfFbbC%Wddo1nC)OC%bAbd!GYeojZugiO)nmK zw-0^WNnrb*l4s?O-33ulmoRrp$GPEl=FsH2NS>EH~ks?Y1n-$KS+E0(W4 zeG%|63PXiiOlJ#l;{$z;_bQ|yfnGWCQ=48hr<;6M#}jQOGyfu|^q2 zj;~r9v7Gu#T!Ot&p^rq`sSH$W#+hk)6;E>CGsna{<)8Ez#?q^}p#YyAScxBf6pN$1 z*`H*N!Vm-I-7bW4WgGcoS1MzJd{8qc3fm56Ah|AU_9{!}4Y8hG?2XzNqA<8aCJe0m z_qb#yRVSCok5F&?%ll{=d0r2HdP^s@5!aA1aVB4Om3ht2^cko%s{m1}TgyX>V%bLy z*Pr#@wM#QG!iCNQk2a#PDwRj)ePA^|5*PZCALR9~-qlpJXN#q3Fmdo~q zJ{V7jh0nVTEb7Voh&<*~t1{V?47llqe*AY0;(gbU_v6+9?WEz-U!pngg?oYA368#gc62i@6fTT6`v& z@cqe)w2(jlDi$9*Z=Aod6}`@7Ku^whXE6IHr}#YS?Sq7VQLq`Cfo0BrA58iR!60M&!_Mc+G&mmW7ycv6Yn7E)%O2eBNH7w~;*Z zEOOKBUenjv^QQzyd7|IKNQA7&K%0~TlniVyr&|A(lV;?^`8<5hGs5UPMy$MSA=FA>L@YAPUbyGca^4-_J%?(j&E4mbCI@?nx9~j=cVBl8+wWPX0Jm zEMOWrr*DaN8S>Oqif$L6BK9?#LBHPqf`i%J{$ESK?k9QOj-ROxwQGlsGV`Tar z8(e-Lg24J(yzarw8FEYucEvEy$PRNxgu<-_-9MFb;j+Vo^q5#dku9^QLy^6o9=Fcy zZAY81{z{_UVjgH$yHGq|L_gP=90WyIpzp7Jbh_IjjI-}~oydRrX5+gn^P{u&%Z{41 zc+;HzzOh;?ADM%%Jxwq)jFB7#lpvZ8hPXxTV75>D^eV9A^)YFZ9G&Xz?U2 z8?I|jSZo(7eUfa^u4yRh*^rBwk&RBjD^TV8ez||#7K{Gi>m08|#E2Z2tW4K^p25P|Ja~pRT!oQYq8lxPvUVClv@%df1Cp>`1&s;Yhkiy zKJRQ3ec|M@W|DVvWBvP>7L}aoI;x@Y__d9^+jQo%k}Gt1!hGa&Ik5S}oYr?SvgmKt z^Ir$!b6+hs?aD!ybtZJLaX`xY*&=gJC>&>M(VXvFoEhg_{-z($oIbuZ@?0ymm>y=;w`8`~^Fl=R#+-XDUd{M^f|`T15- zc+4fwc<&TN zF{D$Xq&>95@qTJFHRpA8AP4pICS05nD`|xw_>z7I5h{J9^5nDOq8s+_Sp43 z6wQ6L&~GQ-x4MEXK#a8BYLAlNOW>r?VRSdv>Z>wG_)ff39qYiHw{Z6Vv?yE1S)Vs1 z=z1TJ$!~1Yk-XlYWm+`kbw1|431{xdOYs>Sj3cjCi|_xA*lcuYqwuKwGeNGGS)tOx zFnk)W`!8?%XHyeCMaPS})E4W>sXa?$F7tpKyxGe8>u{Wm>0pa()?s*dPm6uz1alr% zVB?$vvh$=JM%D~P#Fr#=_?iPvV|p9=B*;x(Z}sQXXZMrYqEEA-nOT7omhn>kfHgd7 zgre_iE&fQz#>`|B1`dpuZ#UXwem-;67w9mxe=c_1rMI+woE+_GhmYiZ&7H|D=Fq1} z|J~Q;^c!Z_qAIhv*`D5+~93cQ{4{&9KD?a)JTmK;7w2O#in6t*~FFc-mouZz%4^lB+$Ci%py8 zOPw4q#?$250{D6TN<#U*Y?%F`=dn|QbT+fa(25YaR@cIH)c<^uS>I#i{!BY~`-Pwr zpEIu(vG-C_;Sqd2MwTX7qjXXzs`9#8`&SOu7gs>HD^@C9vqjyxAsAJIvv3Axug+wy z_tFG;>T8WTe4bcV=j-pyY}BW`Urxoy=QKNHFju;BIdi>vogb{F@YwIo8R?bQ%&rN= zxOe2KopUgDe+3#^BuLO&8vf!DjJ888`OO!B zIxMWlK9f0p_1ak3pKk*X^I)u=OFlF>2dRAitUAFw^mH4nTojHVOLCEebMU^M!oxC( z&zUpKa9bZnCR&S$d_6mQIw&u!4i1*TQ#74zofym6ZQj$v2RvNq+rbzWqiUUE^NK7ZcXv!fE@Mdgw#;dJe6*p(<#vUKu`?|JA0 zt@OXftU%`M9Nfz~dkd{p<+J5bZ+Zj{B+CWXbzSf3WZFN;;@V3q({JizZj%&w(wQ}c z>&bG{Hc7fhCrUqaW;#vaoa>4N`4q2{R9@Gc$WC5en<&#VQe~u9swg?`DvCI{SRox0s62VA04xh@lM`^jWYq43tD)doEr z>*_fNp~H>JdemqAtb5~RT%SR|&U!i6J<8x>cGow?JF^gZn$${%#Up-#kW6z-x z|LiUDi+l!e4Ax;6``M>i^J>mIPI#^!D%Rf2*XdBNrXKx2>F_N_hv6FLU+^__)#~uX zH4mws^N{;1AJme=F+o#F&7EXSeLiu9P&)EiSy}WNMvTmH*$#jJgo7~ zML26zHw?L`@gWztZ1NG^IG@?}tmm`m-PFVx3_~8?vSu@VYaV;C%$Qc?V(7_S{MeI+ z0`|WrHOWWcZg~hR$weCLOB*LL`)!$vczSh^CWQ_%Xp6O!SGSXPSDZyR&{^IewwH`v zE)sjtN{+p@5!>sWm;Y!Z!;%~X8Ifd08je$d|-SD?TM8`h2^%rMMKi8Rh3S(LGcJE%g6 z)yzHgrQaY*fn)r$dkrReTv{##MJCaBv1c)}LIyjVq__$*t0$IAj~E5dzDiu=-%+_# zfoVOI=seXVw^Mwfb@D;~;mp|>Qs+QS-bI#i5wkb;2IBcT zI*ls)FuJ8bG~4`9y4(l*Hqj9=(;t=I_+w0@AJ(wfJ&*kXGxl}Mu190xDh;|^j7Iw> ztdHL%r?`PRxl_q8zGbdaWHg4Ec- zANFaGH?!gJmpK0z zNQN=IPZrFt8t@|BfW}3veO1cD?Y0J3tTAx!O-GVvCJq#4(cwiOq=~!(zfVGCdL9i1 zD8{mvO%}5GNcNAd*h8OX#5~sg>rNz#=*QkZnDKXfF8LuMif`D z-?Y|D|~?sx@IgyBQrKi5;Z-4F{Q3&0a<(rLDL% z`z>F(nW6O9GOSSc-vL>jEGiSeL`#uGlwNPN4nG$xBDrDGm1yT}BQqo3&8+%PM zW4Iao9V+By7X|k3Rp9V$vJfZ8JG!$cNJb)=_nl|90u5HNmy)W$uSq6R%`205Ka)Hf zYm#q0$wWHR?RdL_xsK&B_+6RYX6AZ9JwJ@h_r=5iL)u%nMcKV!+XHrY5Q>P@5O#x} z2X^1Y0JhlOEopZFV`8Ah%m8*X45+u=l-&h`o#ed7{d=}|dp^MPhZ~46jMvOs*IMh` z&;3}dLN|IEU)J|Wlj`IWhp8~JfS*L}d~M>-937-aR6k}_&m!+opZU{UqOqoPG&%*UG4Bq0bH|V~ z9u|$lDP(+#nDxQmSG9^7-7UzFsOV;N;>Q6Q^qyVB_V>)H@=so+Wb(72csg z@qRk))nPU(YjVpX)6k(~I=08Bqc!VuBbKLQU=5x_#q(^e9rMC$GZ2};+>HffkdKiq zCf|7b7kLzpso?o^TD4Ed!p`K1_`MINlb_i{W|B48+8n2US7cyCB)zK-@-c|-{rdKw zVBWp}W4(-6evi59W=5zt^L#a;0OQ<@@a|rK9#sl3fa5Irni2Xqj-51qoKt`@%L3H$ z;2(~yJ-J2%?aRmD+jO#=W*ze#&j`EdD}KGt2%ZBu z(777GT>0*|yV$tBx=@h)yzA@=yY!LMPU*Y#i}nmnov3de;-h~&=}_te+hkAI4l2)@ zVGB~LG>h^mdix@^-KkU$&!$y9R{grHuit!{=ak`mmS2Q(PVW!d2Tm zr#@ibvq!SnE!WAYZCVMsnk0)7H8MXoDzWa03o4Q`{J5K$&)?`*v~$5?_GzBJ zt;BDg3j*fTzs&mzYyxPZgXCC`zxMnokALphHtGO;5HBE>4YqgmAj}~b<4YRq(G?Hzsr%Zx*E%vs! z>(Ga5L&bjbkRCc*iqavay$)Awbo9{j9Et0|YUa6kJ}et^N9JH?a1PR^WuZjP-rHh& zvRJPidz<^Qw)C1!$iW)_Y{Y1o1-g?xsZH1?!*ykkLaz6Q(bGsSX8T3D(CYGhFp}#= zaznpz$vKA5cf&fYjVcFT54h*!f*bf4PD z*!nKgLAjjT)SPw5*#?YruS7O*$DydM5gk$9_?OXwC@-IiFPJ z91{QCi0ZS9XrgW>JyyENd>0p~RohJ#opzPQjp#>=;aYFMImVI)DSy}u;hqYN)sRP9 z>5q1H{`jT{q*FNnUA_G=+`}JF$e(>nqEC-=b;c-iD(jgU6|aWp-gKxqe`aT#T3g`_o;@f7rr>}D^=5;#VkJ*!n zE#=fQSLqhwBx@@&FMMDdNqJvNCp7zh7SY)>)eO^{nDgx34C6H_U~nKKF6oOr?T3a{ z{1KAui)UeK#PRpL^4b(Bcc8`w`mXLqq1|`#f_y%`r)5Cr&2`r;KEEHl2bmSXZX#Wp zbLh`aB!fDZb2YEg&EZZm^+h{Lhj!1v4^AnFVWx-Q~;V{SF1n zP%6ov*^kiHAOB{maI1bG2BrHWF@t~Sn$+@ZG)DH|y|)GX2>AEUyU7&&HDK^H0}}Y& zSvfER^WS8k?^}M}`V)>UDnK}`?^Kpbd zk99_+$QjnohpLk09eW!8lrf8;whO**C3BJQijiMk@u@F+3j4U=M@~3yB{1_PCLG3v z5oq{4oLnmV0N1m2&bcRr^U7I%zSWL<*uhDt#C_k&Q5^IAb8%`Wb17$V&e)xUf8)qI zkSDm=jgH2z3a@YELhA8rk>v5C@6#=O>zK4@sFRM}lI7)Pogjd{kK`}5dXkIls>H)x zWG~9oMXYC@eC6=6eD!qT%oWoNim`$m}JnpG&59BpdIg-o%q~F@&1%XCjT3~ z!Q>t?dGB&B3&m$%pJ@-tTMQ)A-ZKfIw{@sv(BbiLDfq#D0kR-U-d`^c;=S(!J;WdBw&MLLv504yN_sBd z(Ql>AK||hmCi2=ebmcv0RW{;+6<#l%E4=)(6kd7P$fxkEeKC2$qJdhOS20Q4#~hVq zlaGkiDV_X0oG9z7lO?L+3j0gU?Bw}Vw};FS<@M=2fG%bCaM+#Ty?JsN9tALa77>VU zLU(3EEdqH)v(hyQmaB9qc*OkIOSxDufqeeD94t!W{Y{^Pm+!ODXtKg<+#vEzWJ1>4 zntA#4W$rY2%Wd@LejaQuTi3UhNn_mPhSEizJW|SYy65+;Hpe~oU_IvjVtgM3ylR%p ztT@g!LH>we7>HpO{%EwE{MTfEICkMW|6Vi#Ox#uN-p>JlS){y|TlM z)?)X>Rh%u|IjOioys<5RjXrqu{QUTFX- z-}A%D@&4%e$`4KEvNwxo2V=ErW@qg{`**y*b3R--f%75fzz450F#8Fek%Q@9&Q6EL zsRA6W#d)yBf4u?BNZ?+&_#E?$qn*W`{NlnX?y}>nv$VBiPi)Ul@(5-as4A67;R>8? zXp)k}W~lO-ds)9g?BJQo===Vd8WVu33;p2Nk@IwUHOj2j__CCHuSJ}f`|ZG|Z&9%K zvWFQ{8}m%xZapUpXEL;=9*4XF}s|5POg9IRpVKZzY4h> z)i_#*+~5c98HdyJ8OM7o_nS{k3{Z|_7B^orhr{fh;CiFp_cY|+Ex>Un@|D~hy;#b7 zDbF%4j$}W_J{R#YqZ4{*Ysq`tT&_2El}A1<5-`&Yu9eH-!4q@5sH?!$Dhj+gSth*) z@a#$F4|}^nwCbUPVU3FU&jGOZj%MF2`|o(2QrR2Of%mV;*n#jX+#~8UFd;SroxC&f zF(m`NUNdu&uhqqMbRDaiThW&Hu2sf=L-FBkg!8!^I?q0FuBV@M&B5_nxtK9j;nmqv z;WgJ+;bqDB(7gw1=AkNMv#D_a$WHt7_P33;cDIDorBCvBlug~Rh{GJ#NS(7sJYL~=*09%Du*#?D|{xxgz z-xOZMxkoOJ(@1lpR&MgzY+kLEbIUYRvYR!DJuX=N-37TXxzC*ELYE+2mVCc7;e8@u zM;Jc1MPP&>9JRkPgV3Jm_SJOQ-z*77lXX~AJqfdRai7*C2eCXKzx0dzLVcD$Dzq7!;CYlM71KPLk_yB(j)ScO*xKmY%EMvuwOWEXiW z4S71Rn~~@}!hq_N^I>LeBKwwc#We4v*+Bv#^zI1!YoUyD!fZqVV%`8V2g}Q0u<6;Czt`X;1Et+|9z9Y3TXw zBl^v-kV|j=NXaN~RDH=DVe)rQEAmkNfsIrjQ!F;Kym{}BLM%C^0ewEA`6oWlgd$l@ zzU=CRD3rEi{%qfTEL+q>HZLud#(CZt{W=N<$EV@Y;g9&YcN0k*TOy+;`vG5~cz(vL zk;8fHW44ry)eEHtIiLzUdg68(xE9RE^%!fh*8CN>LO+;gk{`UsoZNGHI6JU~_;xFj z?ujZm|A@l%)6Dh0%G{94*FM4j~b*n>8&_EAnGaDH;wn$varGESxg%2kT zxc-!$z8=ogQiB)@56Aq5M6OO3`pTwg_@|5E0;jL1h|clrva7fI+?Uo5P{{Ni&4 zyt86n_S)u>FtbR~zxkqc1G&puysvfVy|m0io{_`dK@PED0Qs+q2Chfh@0?~W4|oQx z^7lcqo_SF3(s&K%yL?brM&2tDpL#wh-5iO;9M%r#10A8NFYkK%m6bfN?Ny#U?5T8I zYoCYJ5e+4CCG)u3_@U1$=58NPLvuqOOh21T-4!LWqNfim?nS{f#sG=T$0+*m4)5pd zYwv^d7LnMUuE*--`B;C_PC9y)$fMGKaN;n%kRTs7^&>s|wo+>X{iOch%ycGi`z;O0 zw)q%QkKWSm#nLF*2cw#mJ;yxD z=UJMC)b%ct!lmR)yVGfLihN}b^UXOf+P(iPrz`s6C;2t&Yy-J?W>^F@5@+usc~{>L zo(}YeKTE^tMR}0PO=Sb?an&7t@ppVQLWLZ3MXrq}Hxy&TQt3fn(wX_l-}t&49rM{c z&{ziP3Pt7ai$JbZKD=O#whuYta7)3IBDrvcIZS8Bv62s+Ta$i3dIqnJ`Ym}sy^-EF z8eZg-Q^|2Jf80cN-TF&L#T!-)qEMxOItnJ`W4^DAG*06D$@lZLJyGy)Yry&6VzAnv=autuoLBu#hQxyIoU)lNIM_663l$BA15_OutH#Z7)`OIyvmXCu+ zT8MkQB59P#|1amOn|;ZFUd%`B06RHV@SAfY-w)#=abdgx1#9#0rkACd_LRwuFW$J6 z7KxZ(1MfBTC$?)L(`y&W=7XHi2S;I4fdLku^H4OVv7FdZBs0tVAjgWYS8oHF?jq+t z+lF&n)ECH(^B0L-Oml1D%SYn9x>(Wuuu}YB1q-(E*7b#&c%+)IR-A z#DKP0nC@Z1ME`g?haC~~Efl{jG#Hbag-zxPud5g0q&Aw7(&|Cbx8^x0j4Q*itB2)TReB5?hXO0f50Vd! zIaY?6iw?-|drpYA4a27%8vG`YwuC%ah1G||u+tHj>V;y<2@QVm-1^{7@=6us=~3nX zYh);HNAUGMMqg7oh1bYmv2wkfBiarK#rUTh`i016IVrqs*2c-Iy3BSO913?nPksMv zI*r(OTP|J}+-Dy51p4Ew$!VU=f?s{^0s6+Rd2F_=W?Q-TacjxO^g*nu#$l0Z7u$%m* zntW(m=9oLUJ7etj5NH=C!m5<-p8|eAbCaieI3kSP=(@ieoLi8^GiHTX*D0}b`jR6K z_yyC=pg~9Sq$NQn6Z8+D*D~RN3~o)QSZWwz$%`eEQ@cE$ zx#5H8I2&n?Y06+MDo4NM)-3e!p;yijCqB%?nmL&~+VVuSh{?qL-h7^l1o;-`jFzi; zwiKF(nOm~3W|Rqy+8&bE-yP7ma2a+D(%}5$Y>dh_;ZM(4d34Vn*XdjQ<;i@~{^Z~q zD!j4}kW+h2zAru)#n%&2I-B|FCKDV69+p)x_E>)+6pbp7m*M!WpJGDGLmIiv|F1SP z7$??iu;d~+TyGOBYH20yIdj;D2BYW~$JfU!Slutfr6&i)aL^H1_kuCaQ;V&MnOI3) z&+O?T>GsVLrad8OI7EvYO|$U#dnvwqCrAf!iwj*s@Qv4bTTm9_N7KhQE>>=nKegBp zf~DUR@gO-1ip3_xlh^B4n|ZO_L&@zV;#cD=7>s2YZ5=PwD?4N8xG=J=TIBDizwciY z4*%LOW&FJby+YxaszvX)%#ojFf>rWCxn7HIkLjV9mO!rXStffsO*m*BCy6tdM_e-m zU&(dW^&q2D)x`V@t(;D9!qNVrsGUK+lJnTCg(h50jg_nR%s5LAMaMx}OmX7-nY>VvU-RMKS6^g)H8a&*a1%L9+A0x?J_i) z&nyGZOAaSYXgVWK#&|j6o@WSD++Pfu#X3?V^JG@XNif0b9JrWtZ|N~ z<>8_F+mFpWl2^L$)|9O|E{@<7D^>tI4cxGi}dk$_=&SPZUE04nL9jPAYt8`oK zT27zvs-5TZz+GM43bm<2lB#-cHM~vzJ9U9RA)t}xd|3|Np7N_DR?txBD1SZPZ&CIo^7ccu~>m+goSx;sTeTrsX;_gxTFow14IZ0wu zGf6Cl$IG$DTImx*=OXhIs--1KC^N%5)r*s_RkYH&k%s4m8rfKxJ+76tvM^99Gh#K; zGDsuGPbA5f1g&g1mMAXE;^j^St=P6pl8j7^Y@W{E_D{~tO>sdJa*OrZkAKyR{rBr# zkj}mLmnEzvkD*J!$_?coDe-i&8|-XS;C$0+f2Gg-u5%#psML=?xakJ1GW zt(o0)TnRfD@`{t4k>skRv(pt;^^|0Nlu&SNeyqzq{R=XUN;ecJmFOm}FiQ_djSKYW z{2PYqDdDKf+Vj^XVfZ^J9AjpO!{JFdtnP(jYQqRDUmK2Us&FKC3x`Kw7@q771Ddi& z{|$Wsox&mW!qER79Xrc-uKgqoy>F9Ubfw?megqyK=b1`KDECpURZA%1U-At6Rv0`R z@f>_*IQ|~v&)KoYvxx3t)~9Ro3_P+5dr5Q2AdaSQN5eHu4>}mnYO$#=GoJc0n~P`X z^(}Zt#Pvx3Hmq@6X5INGzsI0uEnSD|adi0{WHw+HYY@wM&bE{8g89sd+NQ-3GaY=& zSl3>|IycYcezN{ONR@=wQCe7w4(s_d4g+*(xHkvO`sZNI{%knCqI=OU2NPLuK7K0) zT?)zY^L%Uu|LsL~Hp<DWXL38%(jy%Ua>OAHT+VFg5IcwgVoaId8 z7IKC@m%BUMB=(?-#N|55!AMt$Z_`nFpK2iuVp_?-vvkV6Xeo^%Tg!yu_OfoOgR~gt zB6Ci+m5c0E?`-Zacjq>jRyJ-j=#ah4o@y_Bf3au$gsZ$OD#Tfyoqih8>ZOGJO>9E`-VBx3zagw3EeST1>D(tUvnW{DWlC0>7YPsC2I}$S&JQ` zK*)5H9DPO)&}wE27MtOG0|m1mOJ(phlbF*3ciLWo#9yUiWdG?_{@a9qm{09Zw|zqe z%1<;&6R^ksAzeZWGyIG+$Aozb#N^Wv)1yS9hMHvc7UmT$qC;*^sVEnyuEnX{V;Q?3T=C;kUg7uLzRc3 zIK>bDcJ)VX7rGvKu086P9|k6JZ|~1~_HsXX-ws6T7k?ax2e3^u0xMkNlhG(<@k?=Q)0D z?&TD3xZiz2zv3h^QX|y#_ebM-fAR#{Xhd16(P@|(!o5p&1-cif(P3YXE`zCb-1Biq zyQ^`Fwd_Isvwn^m<}1lH)~7c}rN-`@D8xNXN4X%@{dr!}D}-*vII;-O$X)#;mspid z0RMgCi*)RKZonYcd`8*uTzpgpwujUGb|D=XSmU^vl@8;PbTkSjJMh|o$+I$$&+q$| z!QS0W12eH%2YzWll@Bw{>)V$xlcFZ)0hJG1u+*_V`NVOJ#g2^ zUfrSB=N7$k4UMRGg}H!}3gE`aue#BQ39ad8s$M{@*oZJCAD>R5mD`Ls8bo*8XZn(+ zGSh1Sb13J#%d!p*a`Kvkv>DMtEbSd-SZ#N?VCEowPV)V~#!ZIbcb9}%XZiY;u7wNq z7cFv?F3J|tu(_RFZQ4e9Pj!<8{hZ|l$CP1~oxFaol&W2vr9(|;ahPi_A7?0Kev$L=}SLUQw3cb3Jf1pA{Ip) z6Dv(Jb8o3kcPoeO26GH#9qoQU1=cK~YimKNtfY&v*FAC&niBcYg*ojH6xbG3Dsy_% zx7dU($9U#@)+m$J)k`HhvW)%F^r~{4MUrFOYDGTsrUDC2mP-9@3M}qzhT50SFzI5M zR3+~_F;|7%WK5nPQNiQ03Qa38OPZW-UHD4XL??*<(v`&HQgNQIr10+GYQ?uT&! zzBp_2M*_!W(18HdT;hvCgH+5C-GQI0I8F@odc0x2dJ8prsoBSwL1$^tXdH85?&cWg z%k|+HSf^(8E3-HG^&r;q?rvgkSFjq(`||4?Hzzui8SbsdOfUM!mXJSgy926L>i^aH zY}V2<#X4mF+G>2_`E%qDj=33X%nzn-^$>j~f#g~^2CF2Ji7=33Nio21Ivr!%vmd!@ z1}3>>pud)^@ZNNUm8Rol_Y5@mrHdtuW05tw4F3$&H>Vr5)PR?J$W&Y*<5)2R>Mi78 zhNfeXDFatob4`!o82yxn!?QDxXG@<8$LOLW^2DrRt!}63=~%< zM>vx??O*ay`8hqOkBxYCm#lB55zWm$A=sAgQvOl@B`-{Ohu0V8v%WE6D%rz~cVvFa zGX`20U|N6?(I;73Eihu#KzdPGJ1oz!7qr%hv48S$ZMPBUjr6hgp#OvCTz^vNg&b)_ zV;_1SryEgloD6aT*_6RgJk))!>CHw?*N?mI=9zf6xqh_SmefftKXp!<)HC&NVI}?T zRv$gRsy_2@+g!`@Lv9;=pTt3)i~i=O-b?J_@gh0hb6%rWo|&o^`q1sc`U?ZDd!+5@ zkk)JAVb2i7L(lp@CV4jf)+lYV$7OxrXRr1Br=+I_S8tdWS6R`mSz8zVz*Za2+n(8? zKjPOQZPRRhs)Zp@mgI8pzV4{ZpG`&)%$SbQ$di*?yS3Cvvz0nwAD`q}GY|5HPO3hp zr(?55#?RA;{S0!50~2N4jU=(uYUTE=MA`j5QFh!k$+$487>MxWlZ;Pf9#{ro@Qx%*wj2 zL}TuUD^796f|{;SDqIoT(FF++E_mjrL>TLAJJ-1IUO_ki6D6}3*b~EEmtzf`F<=Mt z;fQ$8z35?bB1ln3`+Qa^aY>iH}(!3HNxuHGHuSl|G5Z#KQRe2* zsYkYv_0y!6>~UE}ZgDf$f?LVEaQ!&*64#F8fqMC5;M z!i>r#n@KnKu5A2XLI-#ezt6~Zr%w*^q3H?vK-V{WYSb0zz~Q=bku%qhSN|{1cz>Of zT**;N#{#9?%yf|c1+8V_eizB_W`?IX&9Qlvf_V#Ei#eJ>ZBSqb=ibb_Dp=kLz||bC zp%$|*V~q+K$LROF#yK!5ntAbDPjKDxAv79Wd9VMqH62-;lfpPxZSKS@NT+nPa^hUW zb9C3?biBs#p4`QV49*wB>1>KyEhWI)MLz#>laKpaN!>PNF3ylgdqv(p#|$Tn znYY-8a7cKdQd71f8dGO;9BfKWl(YU6yID0B3o}R`%XeEV?ZREvC zdL#4A@TH3xmdr89nQ81Ja5aOwy*WIu(mlxQV@F=bdQc#qr3B*Mk3ekgxC2(_=m7SK zM&52ZlYT{Gur3;j-^mrkq+==P;nk~{i}{TAf!XPp;bp|kLv%$)v&Z6M0cLQ0v%!`w zTU`tJe#A{C%xWchciT#hg3A5*9fxuFV$rFc&`}F9B!_;%&s%9^I|$Q!ht`$XpyOz)QL{-OrPCILp7&Mg3`ji*)bmE~g7yi?Y;FieJ0Rr^f6p>QoNBcbK84 zg&Drzq5t`V8S2u5SZRw2B{%)aSqCCvgFnuX48)O%bV#sn=NuW0hUa0#M5D;5d|Y0Dfwy=c(G;Na#P+f|z9n$o|6eE@-jK1@>Odqx_~snc5j6#?omu zDI8Bc$)g2?zI)_gxo`a^2#ll zf72|7KTD?Ipu(&7BYLeylWWXYcvalSe9W;&q{WUTDdzpG`x>3hNlX!|={k8hm06um zuBcYq4Gwi%qQ-3{j`_O4+AIRjY2hg4JZm;E93{`g5Wx90@0Jc7(>Qnb)?%@a`)8h& zPvbtkm~)eFL^hnKlG__YU*y?rIzVzUg$&~cvMCeu6kcz}Fk3m73?ay)bx4t|r*-1i zBS}`?(Mh>FN92nq8IcfI)c;LJWtS_4v~|VLI9Ci!cfsWY5r_{8M=f5X6nzIqb({u6iDd){SWG(6TJ8(kbRdo}4 z@yTLz9gZ+FkfS;M&2Awk(T@1U^J2WRJmf_G&fv-=#E}J z+}Mx8JZ|zIhR)2T91+1B8=i**M&NdNzD~TS1oucnxSl+{O%nD`;A@t}*XS$f=9FBt zypW4Nr?PQ#UN-8|4cUi$!#r}0+YJh@>*OCcpC$Wgqm|#+j!Tkjl5D4+xx=Icd9glO zyqhtnoNP+mS~uKY=!So`@eJpS3oLk^(w_YSDZIyyNQ}UZjBxfoGxLIHA!l#WiMWSc zWw|88{9+F^&v(Cm&jt?j%%NN^Qh1JVlJ}td-E%N{Ed7<_QsPc2yy9aOUaAt-7Q&bl zR-XK6ShAcLMn`lHoeaLBm38+uvLCK!`G}6ub#555$`z}x9njb&9ibvUd($d)e5(k@u?# zW?tiY9$(m+Oi?X`*Y+!XFKt$M1=MpD#Yk6aUX#6Ht6ZgT)s}K^OABd#&m&^Y@JI+Sz89T~a31)BN$mgFTS90ufr5nGlct@oOi~ z5IU>L`m^7Vd-aOn$)i9My*_lctDNiI zR%(1EG>C7w$ST&h68S93HPWzN2Da-WCFWTsUB!n+1wGS80I{`H5s zYamRARd}#58gF~4F_<6U^Sv|wU*?0KBIEdmy`WARDEh?y%On{KFcpHks_E*WPxCRI)RsI0N}x-}PL23&JeNsG zCqI-9Kd*E+?%`Pt*Jb8>50^h+L?rKDyJ{C;(|x{|>lI+aORbc?&`5V{jVz{re)fc; z@`l+(*87xj+u{n(a2HHTChJWOY;ZXxrgJ{D;`)C%KRPXn!0!|E4{}ai!*kLIZ=Tma zX74%AUB6lCa5qqgUfZ(BB;}yN=WHB5l7qF?=rO;OgU-_wUZwviyn+VuKDM5|+PR#I z__fnt62-DMxwxh}X`??b1ISv|o=6V?_be4TAKoyzBE*OD^uOH0Oms%UlL+Q9vKHzV zffM~X7jdufnERCW?mF}}@Hz0laoR5lv0SIuJfwq{F&n+x1eVr_!0HVVxIk9!W3~=K6PfdKi|5K~*jM$FuEsdt zPraD$lbMa9O7^zb$-zd>i@iBt_bpU-b>cn3K9k(}d$Mv}&AcpmU%j|8MSM$GyEv?q zfVW2^dt{1Svq_d_on7Enq(np>-OJxyvFVu`9CKaa?L?nIU^s?Mia@=%2y7o8fd&t` z7n_y@6YECW?|d$k=>o{qqRCM*mWy)mbZ#!j)?mN=Ccb8sa?tu}Haa~}ctzdf^&xBC zoqY=_oTs;}Qh2pEqLWI+8gZ+WBClWRm^q#zQMZ40XMkMU~bhfXJl;;h0;9&m-!w(U>%MN31O&voo>z1IxJSv6Un}~ zxV7{OyYlY^S_GBPg|RdXN4fqPk&^?%dHSk(PG7?J?%v1rj4Y!^liA?r4|z`=_kVfD zoZrplR^7i+bEOY%FQV@+m_4i=I0m~}%kJ<(X<6SFiGk!_5}6Zvf_cG%8_39Ee`R2- zFP&)Q_-3(>wG(rPM_S8p^-pR0=^s?gi^TBMH0*4Zk4csmGIDdVw9fTLxFhpYZ_?8j zNN?9(3kmZ3CDHf1@%Eo6G$XHfYh)hcE;p77^pvf;Ngv|fDArlh@OwCOevdVkt^vjJ zgL{er!y<9&mI0pD^yRg%67|GClDWzo<*Gy?x;DAXO8K}E(nvCxi>+4qz<&jK9GxDo z`Tg+^$UQOV^wbe=G^77+gtq~^$Y;e?Zz|=Q7E8CU{~)z;6x5cy*B$zZb{;l#F#eJG z?t`HyABCza<^{DTSEy(#R`i-3ddcS>&iv>#hT3L4$9iBb{zZReBsrspGota$j`Mm``pbG*$gVfvB)g6;e)Dmv^GvQE z`Jh`bti){d9~n;H-`|;$2zjqZx9fRWxyecbpZ}DpO?}X&Be^88jrNP?b63?F@+6m52NQ3$brfC{O3m_eXAP%R&Q!I_9C_rbcqEYOzcV`Ukn(N2Mxw zALjjJ{Qf4AdjGF1PV&KlKjhbVe;%2`$KTXg;9Mf<SMa`Tw0tes(8)j$;eu z`ILX~d3Gf9Mg0Hj^I%zIC7&A5*GBK2YsDyBYsS3k`pnx6qaX0nZ}Bhj1zJU+yj>c? z!}IZ}26Km_isfV{Urgy1i6K1=n3lsl?nVuz_6>4gV}0?MuWvRvzCB~}@Hf7$3|v?w zWhyVV<~8p;(e{4PC_gM{*h-rsZK?XDjh|^jjXy@I~FLkvQ@v z4eH+cxO}3a3{5PQYfF4EGk|_fGoG9N{D}H@tz_ldVrfr4@!JM+fBtE>A^G?+yp|Yt z{FT5F%-tT&9P<{;C8tkNd7+uyoc>qVSMY_!Xy%FEC(pYjA6GlrNPIPNltDg7;&r|< z&48AD$Wd;zlk%&J<@}d_5IiIbbA!|2q|U>nZ4D&qL5Wlv?+ukU3LTmoSeMDe*d|RS z$f8*EZoZh$@!Kqj84=_h^L#C(hD(u%i!c6d5{cKP^eVp1qvN-}^t|y)QqB#=d}S1x zuT8_({^SZH8%p!5^at?yS0J}&|1k~Amgk`?)J{&*XK-tSAG$q>g#T|n=4kU!(8faY zDlvzBhYzx5M8bnS;Fo#%@HRG;(f|CGm8E>Yb%;V8zFzwEeExGS#AP+d#U*d7{7BxJ zXUapSO;@ZW-M>iAR#8FA^YYI_ z_&9vM9D|$7<>F!)L2qfKO%(ntqi3)rA0^fnGMN11@9o|=dwe_8ybd)+v!8Gzxk7TX z#tJ^DG=TZ_k!h&kh<-_WAsh4guW0Fu)#O+=H=xh7=p)w6w3AuA|Hzp4%#Y^d|E|hB zkt2Cnyv;%uX-Z|=2wx0Y6p1kfk z0W-ak#c}cIS{gpw%*QZSYx#EUkIcT|4NLPVoV>#MZCM^JOll$l&V>@Q(Hk+LQP@ZB z_<`{wTqZXbed2HNnc#yD=g2QB(y(uAK7tb2Cq*8-a;XnG(%TDz9+SyY_Bv-HW%K^X zUHUgKa{hU3oyPModTHNUi_-K*GB%TkZOn`)8v`Dy@|kPgP@b>)EslI0$MAhv+|+=d zmds&~u#z#X8^!eV#gC~`n9uLO-6apR`m@&i{+IOo=8Z+uSyOZ;XPxsAIynbuGAWUCDgsm^gWu=ZN*& zLU7xP&g94}tRPo7h&?yI3hmJaVd#ELi~UWqFtohFYeJPc_6#^;|9|<{ZxZ3>%AS?0 zWtg`wR_e}TzH0C?7#zqq6=jkoD??@5y|Qkv1AaaUL7jh@yIPio6K$AzF_hfd0cY4H zEW^lr4Z7I#|5c7$q-VUGAlK>NITX?KnoYe-zu_ViE;czVbLu(Z(C9E!<$m`;a2EOv zHeuP~gJM&i{94x#^w9DQg&dz#Hxv6ZY0rDz;;O@kSFf=g1!obbzKP1d)IEIIlCYsxO~^ zK&*VH&(1S93|(t!;dC+^%O{yI>)~OsD|CVb*F75Hnsj3}-J~XDU5J&t^_|f_ektyn zCnE44@}6VpS-Vbe!!HN?qPNZ?Tm!cgS-AeO44*q3lB_f*oV~)Y?@Pp)Hd!d{Z^AA2 zL*lWE-br$x@8@Yym9LjW4}SgMLo(gyfIe=)Fb~jR!7ZLc)HEUDCcnSX8Sjn+qmr`* zq4k(A^t231hsDdpSO<)37mTZMTHNE~Z);>?AJ$>1HQxylw}P>W=Lyc2m{VNagjYH7 z;`zY=d98wR;I;;{$j$k#AP-o4K+;z`(0d(%G>rz94e7Z%RR-IDco~-G0Dp2@#vh3o zUyIK_yA0j?9FSSoP6&D)0*i_oEH0OY7gx&Ar_n)4ziE#fzI>m5X72WlOgw2=h6Yy; zNN67i3?(<(i|@Aw7R+IHRd~I3J|y*iIw2+{1ntQKdYxx3^P4hksvaxd?CAlt3qjKn zS{xAi@-CTR;_IlPk8cFI)Sw0$^!|~FnoY?6c0C~V-~=1nFgmdKzBOfH5&5+tulWBZ zKfAXu6#pDbgfscm!~-S_>2gpKsyJg&awx7;(2_04MD>{_%-eWSO7A#eX15S%wrR+& zko!w7Lx_<%&Nm#e(K!U&ZMA5|_f_qq9AD%;jakk(%ir5-EWNAz`o-xcY-aB8c=Era zINm*z6ET9krS<~|peL3ckv68_qw`?_HK z=Jl*tm3i^xNfYlMl*D`o6dw&m41aHredMOe! zVVO*iXZWNL6g^FZ9XZXScjRGP?w3Q~9nomnGTa}acgg`zU&lQUm4F_!bsY@fptd6l{L+sI3D+?_NhpWChs4-X!YwH+OC;l?ryBu}~u z^rfyc;l{{A0`izK;mn=q{N{0u*KMo`wwwp9Fh|=oF$8_BxM#e{@lsrdcXtm<`7aJg zOA5xqnau5NPQIS6%m1sNG2n_%s`k$@{jV)%`WJWd^{f7NNZXdUHPt3;yJyE6D?MY* zkJNX%ZyrRQQ?AStWzt4ow4zv66?FM_tnN3 zRvVOPI-Fj`d(OD2QsQis6S^;ULE>d+tiI&}aixQ2k&?a$7c60|`OGmFoFDHBKb|?w zy6A!iYn^eh8C^X)lsGQzi=4nS1WRWevv9%DfzF(7nIYKG6&rL)l*GE=^KCj`E71Kz z{#e^1j6K2h>s0?gXG489GdpMiIYgclwe22((yi<}y~rB1lD@^!JV&1uh7m0zurfEC zS)n{v;@NhM2Vqz`fDT61N#4E>L(>)P#k33OeLoa0`EmCcW?lRU{a>#AAAYVXA*X9g z-%l@Q4~B*#+?>7$J-v&E&k^zFFuob1nkj#1VVSo2Ba znfV0XoBcQ+SGmu%&|4ic=4z3%NsF<~bvWvvMcFi-^G{?QdN%Vcc$QRSGV=$I(76-A z$Ni>7PyZy8EYQ*Iz_Sb6BKgiC;>T&ENOCgph;${7yFa*4fNh%mI86N&IiA8_{Rc%?L?WMp!pA^jQQoz|qft*MD*<~gfO~$HqEM0Sh z&CuAk9A+OT%SHFfy-8(Kj=$ppf9_RlGZZA4WKLX(WNj`JnMs!;*~HD4RdCqHoF`iq z2DVVaHOP*;XH#mM63lgeddRsvwg6+djN9A`NP5Bhtcx`Sj%Kh zcOd_C_DAkqo{21rg83FQRT?r={?U*R^z2Whv*sc>s7v%C_|h+QRSi`T`NRZ%|5iGO zp0oaYhpvLx(U{2nPOCT3s9BqRZmd6SPN7q7N;IO2Sr<7T4f_;kReLks31T52IUdIrFa;7?=adUc*>2i0#QiJ~5#24+ADPOUDCKI`S@LFuRv$ z>ATW#$%3`&&l$LUjV#tTvXaUSSZ}A_;XLc-v8?MKNoTJz^ZfRwW6Xwpe0)sSi3~&| z)*~)>8j*j2%;A2z`p+0qJIIKx&FEJ;$7~6nr=%{)M?q)uSNDx%28?*c+SAC<^eVo~ zhvjRsk^C6X8q3GU1vqT^2_++q$UJJq*N_67QXBCzhOVgX%%5CGk6Z)RrmGg<@+Bi~ zA0lT^m7HXflN=oEEYq!=q*l0{+$(dC5sSzyj&PBlUF;<(hF*n(HlnZRBIA0xi3{0B zpX!b>&x_e#x7=lX2X}eX)lsVMwUtt9=0&@Fgw=9*q>zKKIvsB)=(%s-$Cez-M z2QD?qd)7U!c2J=nUb{)cS3X z(s~N$oyZukQQ*5?flCo|q;f3AeJqw)TgX7}HN&F?{QAFS96Kp6aY2bpsZu5_9TkXJ zMu(!OA3~4&p%KSd&T@YYTtwgLGk~!4^SK6|^xJ!k_$5p6eOO~J; zGtRd971SJS z&)=yq?wg8kMHM!(wzFb<0HR{m^mIhynkzHglgMoxAy?uXO&=v|KD)@4e2YeBj+Jd3 z7hiADlUkLWBLA&j2zyl>nC)IejcWgL95&!Mx*rYoPqM?eqj33K6xMx@!sIsm-s?PP z>dSHTiM76JSdnAr&oBC*;#eOWK$mG)I%2n_GmHDb^HTb&o~6^J zO+JU*$0mEa9+M4lvE`WL<1VU@f$;(9uH zWLfm5%roN94%S918PPq7=aTCRFeKlIrsN!_XXfKXPcpt0nN2p9-0#tR94jDC%&|55 zml6NoG2(s)j>(Qj9G^|DIGP#o>H?_$XIk!MmNbZ@*n)O znrE#39IpmG=0T3X*s;b7pQ~3%8(SHv4+=i$d-u%LFPmK_?c=Pl-jAMn?AHg(=@s9P#|O^(GjLH;dFkj%q+$^FwP zbH1^+v;L68bvDTApakiEP%me{>Sd^nQC_bzO4QZ^V)>|-pV4{=Wk0A-Mb5}n)=Sjo z1M-VGS-q4=vN=tO?OR=7ysE^9ROTGiQ{mBg@`^Fc&6=vh@)gc_FRtkLi1%`?N`y?H z2kfDWb08|{8mO@iN({(X;aNBC1<6KsJ?VmK@h%wj+=VVfH3mm=zd47TqeY2D1C@CB z&J~Y`tI4D*;TfXB%MBI0i?cE1V3uR+XL^$bIcbk4qS2a$gI(KbbcgPPaF|e=mnwV4mDtwj?iEg|jjVTIl$=TYj9o;r{PTK4(_q z*^A?S-I+h=rm|-y^k3`|nvMK-kbAjnK(`{!shIV+pTJod-j_#^QykNj`D%Fv)N025 z-8Am)jJrqrSXYzN)oRrnlNjkv8cq7J#n7d@E;JH&|W6Wnh;qnGi9 z5sObUzq&VBN3w()*!%PDYsRm}tR2mv!z_S%H8b~x-kd}EV#b!w%!W3YG4dU2IkT9f zzLrs>z%H^ z9x?ZUL4&gX$4k1}XCcLx-kCzy@3zrFL%;rizj{n|lTn5?^4DRdM25ANs~ua(KgCL^ zFt8A=9lx^! z5qgc;q1J)u=^BVb%XBE$gPy;IQ5b0zjg^XMRJf)?nBoE&3?o}GEgj`D(#Z~{BXv+Z z^iK*9{k8xPO39~iZ*kY04>dXNLBri7baHE16{M7)RZg-qUM&X(sN~eXQfb(Vd(?ld zvFpAy292Rt>K`j8&jn$zX)vyZ491+jbXfA2YA2bMjZtu{%=ct|6fE4^)oU4z{x8YU zlLr}6GaaY62ih8Kf?Fh+_J*A6IF}Fm7j%Ge1|y5t=IS*H;4_du!r`r?a~C&ptm`UU zSGvk|i@T&JsN{JHXBkdfWB}Ls*Ig}g!chU^cm=kO=6h0Ig9K~tUEA^XM3Q%yqd|BD za{b)*y=_UC@J$_ObGRn%Cf~^Q!Oi0WZabu-^&=BTpENNWoG#%f`RF~j0Qfy^QXtmb=!j^4A!(q+jFSp?aw-X-YSGJ9<7JaeqIrOzf5P zDs#<#e1Lm`7-miP48X#4vPF?PgdEo~k2DH*8%CkkMe-oa`TDM7rwuHm~9__}tG zi><_cawGCPBTSgmEgd8IUYWT!9;!DXCWLH%33I#d=A+N+JXF}jp69Fr+{{Rn1Eq;F znT*5cZ3Zd&dPLNVjM8^BvyhDJnTL|u+p9!VUQ9KpE@OE3H z@ZLr@<06ff_r->EDCv`=+L%PSIWJL8lASl)KPW~rEBC6?jWk=0e9k%6)T&Y1K@C0Y z0Jq4ctlU8-V?23>y5ZR3!+ZD`@*vax&&*#3a%qEWBx3t*Bc9Nm)S)Yx>DVlEsFRIu zH#pPREE|{Kv!}1J^1ej=%zU1V!7zn)!aRkyYrewU!GW`*@rT6R>yX%Yp~nEk@*@IX47?!3*$$9nYsHO|Jkwe-}wXXD^PdcU41yz}X?WC!_>x0?^~Hqahfk<*#cwn-Gp?-NO*uk*tgZ>m_{8u2xUPnd5wqSR1)EhmN#;%mSLttkum~$oycY z=OG)F-e=;rOmonHR3t!RF@%k>lP@=EP2lZxCVphPWm_ms-vW>&cU zq=b2D^!#nI!q_dG?<~}yN?m3&EDgf)8Dt1glHYqb7{vuTSa=Qm+%$?a3_A2sM8T#v z-M*P*DVxxFYe)7 z1ATv;p3@ttF2JX7H)(c{{5yG;(SN(hn3l{oaCeoR8jEb*NalS3vrNa9%9`y8c=}r; zbV>jo{|dmWZGkY+Wm)4z0Intk;^BuVyloW)JksGe@4IU7{W?*P_huhW=zQ9Q`uvRc zaGx=}UpkJgONXLb0ZhCnseP7=WgPEWYUSfyf3B&G+llocr5u0kB-husk;<>#r5=5j z$2KeA_<{ANZ&s*lqN|#-dQS}&$>V#`Fk3^GtG(<2c?cMsf|k{g&&)1ZG>1h3{~bbrbfmgU9Bh=gE9T^PXowNAru>dP9}A z^3u~y#yNUO@|L!8X1SBRT<9nvKP?i${m!~!);NB?9GWVu@usUa+TYTk`Gg?+J0%eA zCpFm2TGgzh8XVrjd(L6>LGRbWzGoEb2hs=4HQs8v3CnqZ*_L$a>oVL3~e{Gin;{6)rl-U}5r zjZ&lM02NwUxiRxR97kixmp5i^aG4e@D*ne1@|sO{*>SEBH@b3u+$IsDUh=%3XT;D` zbd%4d>#sZKbn?xpSw0K1+AzmvBG-xcblH*rntoK_ZCS7I-o1t1+NFsyfcIZN4jQGU zjb1KKX6`hv%=21sK7jqEuTz<==b^+y*2mv*O26^^xc?<$0ri8X?!9+&L)G-_4DcXER5z}{jDww9s6g)Z(}xWE#&aYqurmW@K%vM z-(A(p`(JYBduGsAyNdkc3T8KLOO#!A66IC@L}{4F*FYaYT322N&nV$^hS}G=Mi1Xa zF3udz<3x*5S-fBJX1|@D;X8GV@F_81@e=y}9E{koAQ2B=aNdgjJ(U!*7`yQ|-f%t`8$$%loZgVeljm?>SV9jjm+hIrr6l968hxMjXG* z8u_9`1TM)&RDL#W`eq^IDw#cgR(1uP->1uW=u5g8L+OKVLhtcoUayn6&W}%&|1$LE zJN?Hn9unW0NwUR5FCW*s;L1TI4s=%I9Pc65^;Kdl_d%Cd@n`#L5nCJvtH0<;s2Gmn z1GIP;ZA6l9BIfTkVC`1khefciZ)QC|k9pTu$iJ@6!W1j^%9Lh=`(?o;k1TAo!g~p4 zChW4A)5y;TaAe4QER_g`zIbBkMhuceGBRG<+sd+AA-rVta+Y>+K2OCU)VtE78XnS2R}lk-2BzwFJNR)r3|52eBBGIPKm z+0ai?ESnnnqVu%C)eW*oZHCDrV zdnDAXI}ZI$Pvt%*nNg)sy!tRFdSWCjY7;(x%)#V7_VSv%gR zX(yL#f5{_0|Ndr?Sp1YfSCxx>-5QAU2{}Xu=5a6KziUb=c08s>?_Ya)T)RY4FZ!S~ zmA-N@%)#a+@Z%%U6DS-rjZ!Q=Qmx<#S#ZcIkl)rGN1UO_WDSC`$$ja*<4Jo z*-+-4E0Spye6ehEBtksX(2_jkGKZ!zZ|hHqXAaPP<^tQMry*e(dC44Gxp9o=#TP%M z&Sn3kRvJ?I_+|?mi@73?+h|{W^WxqrCKVnxbFpDabLrqkj+pOrmlYAPI+}{PzjINm zFS*Xmzog_7=j5kG;>G1u)Nsnf^x943#pFU6MgFwpKqUP5KJQzQ$LlryedT`0&Gr0T zsz>6uGi$bUSkvTQOF6h$!ruDhY(De5`S@Q4d3;uGEH&eQOV(IFv^Fy@yG}AroAF}X>A8uNhm++Ih*yqU+zjKiK!{{6BOinW@65~>tlini_w&R+}ZE}v~>B0Q* zJ_6fT(i_2_>(r>pV63jvWRe`3ia7D0(FCl7D<^D^Eg7C6e{>uVE1|^Z3klVZK$D z#!{MDEX$wyyM*1nGYVu<7Z+HUT$wHhtws~y}myV z?T*0EEr}}63x71=an*Z!D$d37b9Z-;ln+0p?NUDfY`*@5Y4oD!VwW_PE`5rn#TND! z>as^hUVFk`=0PX$-)sF#ig-W&E12iw)-<>`&*NNTeR<(mD2I5y`0#js&(Hn#2mV}J zTZvg!B)8aq=u)0P_m5PRz05(Kke6RA+NxOGc-)@ib#H+kuZJhd54LJ5jqJ!F(zk1~KLRr{$zz_$h0D0>Fdj?Bfehs|W?ni45@)fZ8r5lHo;uQnnN zvA-J25BD3k-OYzD}f#=r$2GU#eQ~YcD z;o4I2*AwV1*_?~hpX|i(=1-aH;g9MMBQRk$=c+=;vuh8?NqP?#8kz6e&ww7}$mTZZ zzGTimsmodUaTP+bkoS07N;C0fH+i?Zu~Ib31y7m;dN8a;GbegfCO&7EA@l^F zXRb5i6k+(-jXA151pjcsgy+GmmDBkYnhB5X16U~tzu>2FK4=8L-5c01SGq0-?!9)%75>b&aCnE8x;(fUIx_RUb%UB z@?2wM!kjXFOw$^YwxR+=?-y-BspIKOh%2n0eE4 znR&(It$^OcYE>*yk=wdo=*L2##d&7egw#OMGgUR1%^*9zzr&di1 z=Gg2PUp|k=z%cCO=R41fd*$aA#5|7?|G&w3#Rucsk_4>0Y{s+z3p(tHmFaHI_;*kU zF7bJ`#%H2zEIpDn<7NE6u4t?aLBJ0^Uhw0`G?56opd6@y%dUF z^oRQKbF8EAR#uJY94)!sBzpIn8<^2;#;x`i^mdPz*T-Fv+J(Nw7J6JEx4ZXK8E`&U z>e2J)Tss6a4klnX^Q`Ss%JB6ouS=U;G4=&LssRREI7#1PJoAW|y*ufl6MR#H=|W3D zS1+D-!DUz!y-%*VJ7FGw?(?ejtDeY2b0-U8-D0KjpGquP5C#u>1Ltot;dqC+*s(EE zJIDn??gV4ZU_E@-WMZ}}Ki})I(y56HKDmUV$qe?NT4eJ6vkWa??w3u>AAf#21Xs(E zJL2`Kp1s2RNU2^X9d|}&MJQIx)??hn3~UH3L(!~Qsn*67+v$EAcSVoV(HY3U#(!7H zemTbL?fV@ec<9G`_8%EIb)yVftM|!8xMC#p$6Jrp!!DY&;zPVH4dr!mC3$UnOY2rP zpvi|!tmNw%&GXB$+6jy3g`@=@BW7k|1?R(NCd5i&XBTw18G_$DA6vCEV-Y{EW;q9B zz)p|C@od~EH6p{s+jOGzh)n)$OcEpT2GBMa6!;*^d#-Hr5U zdnA*6vog+x9FXH4E@(C-6w&RN+ukP=z3W&|P)#pS$2&tanY^=?9+49{<2TPj|9hMy z)#Ld>-uchYdemyp8UjDxz*GCBksZWlsZb}Gt^L#h` z%j@l;|Nnl*cZMn{o10jte0jGv#k%RT z_fig8_42BFJ1FJeoXcI@L$;@EdDq^vC^J6gervtw;^%$6+IQ%eQs@3)uNM^>ru_V) zlb6#N-(=6X1{w4&QA(M`^o-2ynN|jQI?E{b?UUrrn*?zxV1GH;AfHN^2Uzux4_mIsMEP*Q#(XalQ({-91t7kU*E%RK_;dK}s zriA0>N#+Bx-q2)gIKp|jTXhb!s*N5 ztmR}a))&(Q%zBc`$S^D&5r)a5v{=wD47FKHiJl&cwXCIhj?iLHKP_Ihp=;-K7<#qV zV)T)4{O&DTZi2=vf88O+J{hd4YOz8&(diPi>VbA){ z=SJw966t;;%gA-M5&vAuI43%ab+9I69dFVBQPGH4KlV$0WaAa<8DFxQ9msk{1^%kl zpT3dYWMN{Y84oVfAv-J!$65Pm_R|cnT-Nl*lTGB~ zi(<`KzTAw7EwiARLw^r@*0Ke#5iha$=+v_UHbV!!Ju^d5RT2Ot3;@ zw-P!1MgiSfiyW{ml}hwMdL5;Uagzd{uCTA$!U|hcm_xn6B15VwkWn=VHt#h!`Ba0Q z8V#Pe34(Xz5Y!m z-YEz{Z#3|3Our&CrGnGg$6XnPkPT6|k`RRkI=U3Uv9DrBZ=xz1yAH6oQOMk>iL9G< z(V^P~9lC@@p<)E{6&;uz_>S2Q<8+w3kvVyNna8w@xz+3u?`WsPQWv@#mymrdBG<+G z|JP7yY2V@ype;<^_9>t>n=Hb$@tp}ZpjoHJAFkv!#0t4HdFazmG|6xLx zcIh}-kcM&W7ZkN;PySgNnmr*?)iWL5@5p8yp<`$wxvCE)=3bfbVZ8~_wJsoSD0|~m zO&D{M^NZut@Ga4V2j+B~KV?F(oe94ius`zBgcu85a}Lb+x|N3er`fmposUV^*h4C% zFOI$R!%dh6eVzC72lM~uf;j#?4`Y(pYrjffk##F$C;AlstI7Mbe_>$XqA&e%&U7)V z^3ivCKK3jkuXw!xb!*dUF*G03+55S@njVR9WGY6}B^Qy8Ug`o&>YI<#{N8`AruOW~ zto)+@<&NiJ!futQ_BzSG^j^gLc9u<9DhW3@OY}NdIpE_aB?&HasbM=Y7CFgnty&PvZv%Y2@uJi$Z(tH*8u3}zScA13o|5a!6 zYvwI1X20s^Oa<1oS0H%46_$6U-;{o$Q@u+iH`pTk-dIE%Q!0wn7OBL?_%tn*@3*b6 zvX>Q>9xss{SIQ*%yaGdcKK8B349U?7Jc;M?6)A9j1KlG-t#GoZ0(F*IHvupo8B9Jh5VJ37pjzjT*|E%^?nmFm z;2@NY*WgAt{ii`1_?rSSWJw_A-`3!EQUDBx0+{O;fPF*#5zsggaa)<&wo8MR`^YZZ z@%hLpZ?z4??`Y3FysQ|Fmb&(GVeGle|WVP>T$)JkTiOhp|w9A%b;o;|e+ z%yPe|gZ`=x?b}2l<9;Me^`cSaqeJ*#WPYH7$2=WO3(3>Oq~r8h6GBF?M>*Yu{2A%! z`S%6P{lwYo?diDPAsuB8O^7(dj4&q?de%t)A7lJr09{^P({b@TYu<-AKl;Ulra5GO zU!Zmv$5bBwJIERG{74<2|G&Ou(q-m(?8!$1{#wa%?)1QXY^g)mMwm5yDi6ySGBdh> zv!}?16>H(g19@((qPy!B*+&yIOC0Gx&Ckbu2l9lrziIQm(u%_FOY+o99Wx2Ct~yHmUj_ z`%_LdOiIb^_d2=Ck1Jm2dNt+TS%*~b<$tD3`>aUW&}dn*-I`@xFNPgVQFklnHFwn- zFUy>yls!xQy)wI7d#-q>PX4xHYI37fjk@mFBze~H{p__r|BhG5Kvl}V-)B9yG~RV~ zXVC^Pd+WbF>rOSwc!fb~=Ou_^wo!I1NR;vPZIwHjDF5_Ll6{;{sqC2`mOBR7RTM9M zJPq<}p;5kYe$m&KKCaJ3xx*aI1yd6xIsSmuJwTUt$zd@xFv|NodWm^%l+z&zGWBVq z+~~`B79_~Iq9n1LGsyCviSp+$gX}q%AQQ(O6xZZLdCPs?k>~8!_2qu8xe}G8st^{a zMlFjH2QRo{{XjLWGn5D&LDuj#nZzf|&#I(?pD$-#4l7YacIEH&bar1#coQ{NH>dC9EPqZr74p?8>};*VnKHV(zq#VjbUx=l zoO3y*Mc*;>)(@gXt6ey%wFrl%Rv5|$(qVOz`$O&*1MbjaHCPM7)iC^g8OrSVFsQh1 z)K1f4#9d~c{RlzD8DZGLz2ErtT4ZaqnD8+SEMLISS>%6${Ba?XVkP*B08_C)l z5%%7IH~vO!`itzzNxJ^6j94|D+~Wcxrg9&-l7Hu=ZxTu`(jT?ifU*2KVx0j#JGq}+ zOGf22IZ2CwjI;s9SG*SuGU5dHr+Y>uV$g0QezE>`w@ViLyWE>C$wD*7Y^+PoLZQjb z*UEiiWpartSyv$Ia_tTGfRo7_mY8wqMHWP|5cn7W>}V$LwB~HgM>7sj%tHJge!mr2 zp-k>Ie{=3-a2A@^F=IV{#@M1PG*yykJVf_nlPq|w&c?=}%&OxavYA5`qF599e|g5) zg(`8=w2%)&oMa{$xxbGq<;OF%j9X=qijGzYx?+X#hEmzsfvjFj1y1}7pf^N=KD`1_ zi5!Lu4MhIufd6G;E}tI7S$ED+T&GvMZxnQMqo6&=IR$UJD{iD=OSTDh=Ckic9xP!% z0Svr`?7p3cVY|4V^LkOWfHMjY=-Bdd6zlO$lKg|c{L^mIca58z;C{|nS|-U8$m{L4 z!jR<(l(SXf__F}qIzlGCEB9Zs2V?bYx_n3YBYmt6yX!_{u8JP(>d~<69EE-S_1|@O zYM=?f9+=QXPcL-ebaebD9ao}0pj(FmJeosBt|PC5L&zAsE5P;5ZZe6^@^#FlTu|gJ z>DFyzxLs@cx$w8VtxzhxZwnjUYTAVe>t zmv;#{`DRhbc}E6gvJRj6(ZkJs)``&f#@c~MSbF)GfQIS!u`2c7PHp64T+pVcp3!xMTIAhjPE_`@z@o7qBo_jeKB{*E#~&|R*jDrM-4QaRtB zUbF^Q_~#n;11}XYv%Y^YIRL#62EcAe5PlEf`}1%xvTp^Ty>%3vx6_3@NQd&?+{at}CWeHu0|G~vL2bkyS7Hi@jtH2SS-d-HginUBV`$i{=SEM$2e%ypB~%i4)k z+txD8(^2jz$j)?gmDeR!*d3w3*ah^C>J;$c@w9?pPo{@`4(E(Ee$}8(@4+Z(O`ql^ z&Q$O->KD!RpZjWOuI1}z>rk^=6gto1esz}#x>o7f%Ht@i(1bUyIYYqL5`Hlc@-Yuz zrjV=DGDE5;56xE7IQN?3Ji;{RP{5{B&f72rJWf(Rt<@NPEXS@GM#C_KIJ6R2=$-LK#_|PZ$6MOCrj|}2IgLqQMpuu8IaeRUoa&bz9SUg z_0B20dyP?e-@2jj_8?zy{}OYL@(;=Oaz=X5jWWwVQL1X_vfONx;?}NcJ5h;Q^jBWu zeCWDfD*6SvDaW-jD!@}&D zE&QAwu?`YPH*rsLpIp1%vMyNa$oGUy(crdOe)N;#9| z#vBU|Dfrb^W_p&%urt5qv)UqedHtC=og6&ZjX?+fG2(ato}SVmCxdH6C|$=vye^t` zI6q&9*tO~@oWn9}^2jR$Ne@t4S!>?|1+5ZuZiVHcDHJR%LuZLT2o3Lh9I$j)0<^GZP zEM^m`nM}xBKqjssImSX}aJv_vbW;H;Jj%z${B|-iw50@EwGnl1&IjypmB#noq+$l= zCcaoB;U4EzYtTLT&?29PDexdO2pO6{OiBvGx5Y!?N*=XqX#n}}NSy!0dPVIhI5mvs zJa829Ogc0#HNkra-DBI+@N9+&SB98SnXj?oXL9eq@)%*rdyVE&InHu7 zrG?lZa^^m$jr5J8r_n|wEjwDIC+Ga;wzfj|RAzpdtl+kQv$dW)^(oE?aQ&K|lLp0N6K1VQM>f~@N+D-Ye? zlCSxZPwzxN0>e0$S(S5S9bDwcS=I$SRdne%N!=GtV))Tg4pn8A3Gc^G6|+wE-69QQ z%4Coyvlbo%;ZZjY?#>LvFfCtGrUnBiXmIWadCF^CPX|Py+$kNLnn$4v?@d4QKJa5j z6J8xjL-7*2vwb;JIyxQgxYww1AP;fncuZHw$JZRrmhC6oI6huFbxoA`enzQN!p!?* zy_Ci#N=|jo&~H;gUq=nkAu7aGAOki|iSKS&{861VO&MBr*g@vJGz{b4hv47qWR=fy zCTIrdhHSVOSJ3;%{qyzqX4s!M zZzAjc%^(Yo7^Qz@gY^H0HT3&QGO{R9<}FcT-aI7+4O7E3MG4ahI^(x-PHP{G|-s+WM zhDVCRJNK}{+jG9c`(c#A`_WEvX)AnVy9Ij1$ih@?<-P1!q6}@8C>^#P zmg@8|{J~zt;-g0Ca7=~26Y0=huY`Mq3O2vh7*pngjZ5er7{vJr+hs6tE&cFPi?MlO zoW0`fxM)ON+e9QcOoUG-W<6JB-qA+huXto(l$qSXE7q+G>5k`n^^NR(c!I*40x9q5 zQ}{kzBYV1lj$w^aRyZA$9Rm$Ac4@p^a56}PeVm`zpvI0KDwNA%rhvN}4r^4f=4UvX zeStO!VVvb+4`F#Y=bXY(E}K68mGmFJWM1O$L>%V5)x#pX_jx}zz919B=9>{a!;H?a zSwm0G!UBF?jk(8IOAeyt8in_1@~|zE6y9Fk2emv)7QZ6r6S(hCpU_L~y$ND9oH<&j z*+*HgLI&@Lmj}|RSzCo~PytqCVHapofoppgn{Z6o9}Xuwy0f=4uY4_M*;*RW@0Jnq zxdz-GO~!Gx8TC76;U+&fk13p4<8ht-gR^H|oDJy7wd(|5S7m;7Yw0?U{Qr2ye38G${K^ce2QMb`CZ z@_y3~amn<9pC29e1Ig$6 zHI;~nV%a^+2W_X3yX4PZPkyS_*!nV9e#xztJ{aRb&WOCyiB-99{?NX(9G%^p>zc&`ch7$R_!x!@-Be6W0v-+dx4Gd`@zxscd2Dbe7 z8Y7YYAqBUtf=1jb+o)Qfc|89~Nlnog{yn=feErAB|-~N})9A=7*DZkr+aMV(HI3 z{1sVWl)rz8h98QcrzI5+ zdEUKjSX;VQ{~^aNl2hY(dZrT3yCJ!VV19I!(L5e_9A@T4!lPd*UXRGd!MsNDeE%=$ z(uCKIk_gO6<@Eu%uwK?g2Czq$FwCDBrabSyr=o{TE;45~7n817!gE+t;rSRnG7U?g zkmt>@6VKve*)uo*6Bf}MSUC;Hp5W>%rR=HthbTl9L7ieMfOreV!xZaK~$uJOaXph&d+n2K?F z){^@-mtQS-zN`yCi)YMt9+`rwOLH-zc{9lwP%L*gGJpB+NGO9+;ocz+VJ&z(2N%jF z7eDOk9*MC@sm#zLCpe;!oUij+QWw+58WI7ACcNGrCvRxyEXN1_lJ2}OxOX@bnfCN| z@c3D4w38YBMKY6~N6n%LY*-+(_Q$xbkr*|L$NA1&&O6nWZ=(w3 zODlhLd$SeI2c)5259XdPbCC6~eoECCA9#^BJa#q}(Y(&bHEhoOy6+O}4dN;2WTstnC{#L9>a7lfP&#+t#boBnOa zgePU_dgOqN-O&=`tC9t1MQ&w2ePO@L(D_B2yddXtnmM7LR{=^1V^{DqH1F0v=@T2ho*}cFC zPy9on7-hg}TYA10mBFpfUa3vq=Nx@ub<&xOeJO+WZVN75ijz(J{*~>)=;UGG{()XI z@->Us#LM{(%%$xfhNouc+a_kh%ApMFr^U(FDo&i~3`OZVJpvzR&|j+XzDs_p?ksXu z?L!gY(|`?pyzfBraZ~q8{nO6KvI#}p>japlnQ<|l`M-MRQ!jOa+KKz$7YWQ1$Uujw z^cd2U_}1itZm0PC-t^f$ra!4SIiq>;(xSix%O3^fOpzWQlj()LWx>&7`^4{qGu~}s zw!#KI^UE?(y@J9!VqTmq^K!%l`ULw-B)@hu6FamPfc)v8GfwDVBN$sw>Tx zdi}=JgGql}@+k`roAyiHe$LpGO>Q*RfK$UV=-4mAmTIx0pXQ2V14D86sh&BK88|zJ zye&D$mGfNS(~WsjB?;)CVut$&3%u6GNxN3gi1!SEIhWo>9{(-LyY=qBU-I5MVm9-R zU$FPkWfA=c9q74J>Sb;&y^1<|=+2W*+?|2W#ieL)ley}<$gxTY+T7IR%=-+?>S)2w zeX;U#q7%k3S9$??&+8jFvwFO}7(&vz~NyHgkGWz~Ksluii7ivi55B0t#7-vS@U{nE0hGmfQ)q9S`L z?qbH>X=S)n6e|&JoH61E{fu|@7+RQtro+e^4&nL8dn+gMiS5{H*;y_VlgaaLRN# zL@RnTFUH5nz!+y#oD>2Zz7G|@XX17ly__R<%Vp-C`ArN(&x+(R-)7*CrOc5(v`?av zoKb#u2%H^QW8?eTqGuT%PD+plIv4C^j`??9$13xDi9Bk7P1yli8|sSRmSD~sGnY9y z6B*|$7;d*;YCAdO;NDPFU7$zErVQ4{$QM70lj@ExsMwR7CeJ(P8JRdo&e|;`PHe`y z;@>@?ND@7|?&0-qD7n|q2c*juSM=Qxj5$*cNN^;-yxxNDo%YK}cX}rWhG61#J;IJ= zaBkm%<|X^2i0A3ur6IUa-Y}pouiI)1o@&TxE_Eia5e&_9@|)YtIFMC_S$FqI#0^JG zzZi_sysj2bp;z=Eujhe#rA>|_W(*C%+EIF3<@@}!53eUj_RE7aE_mk?f+-*3IooB% z@d@-!wvCYohh4F97eC*n^gsU0z$JwR<;%y(Y0i#MA%{MpuO8YKnRI(tFrI!jkai|NTz6PTwuiJs-;wR4G`95u*_*fj_To!^w%k`)+%uIJ_ z8UE}MD~`O*&!(?)qm2PSczh0GZSlW;SZjqsad79Q=11y?@VEc_@BjY#|Nj1ef9Joy zTj$Gt&qv8(h5N}#Q#?G~S6BA5yEQU-!M%s)eWJ#t z4%N;`xn&GUQTMo#5*&O!*|~61$_l^9sfDk`rD%UAr98WFu4_5F$I0c^H1$07HYFwh zWB23_V{fF~O)l|jly=AS^hh_aO<&x-zK*(((&ypzGjPLvq-Eu@N3hE<7|0=+>T!a1v%e^6fBI3$bj86~(}y!>&1J@B?`C7ks6ty;=Koz#V*P$*RI|?1(!zW6obIPZ8=p}8vJZv*LoInG@{TUy_}exN#~QOIe&tg1#y;T( zabal78DPit%z2*9xlxxy)=rIBev5sTCPvKI&0bHw0RxwEwsax6#s~v!RxwLZXMj^% zGK*JgU#$_iHl-w9kS+*oPR-uOrRynV8Mq7ked{W~fmMTcUhkGpi4jMHcJO7hBoitBs7b zC}r#)9)d+}nD0?0v*}CRy3>m6ofTTJuQ;Hc6?T@lf^%xAjA3svO3$7HSYNMcjW0$E zIq=`o{Z*;NyII4bjRGM7)-Zllp#2vG=Qu6$h5d@#@nj$M7Mb+4R2&|#Uuh|o&txTM z`H-93!RO9VV8TQN4D5f`cA`&bY&rNhXMUp2ADw#yaW6qHTu~r`nX6R!l?K-n=v!p% z{Pi1p`k!cUne~T1KLo&sd{y1q^eD1cY`=hEBiBNl+Q0puEOHF$q35EFfaum?dHkV_ZcZa(MyKsc5Jz-?3@J)Ihu(xc#E7lozv zv6evH|;4e;HYq5Xql#czwSc4BGTgczLub^jf0rRFO(hp&M0o!|<=qP0lAel#vhFP{H ztlhKcGm|y@>3zsGPNqkPkH6ziUW?Ds}@`tR4G8f^gM)L$VY`B_E+-rF{pk4)YA*_ z;Z`1&-emUWI(j9J(E&N80FkrFK2D}@rw4oHITx9uhC+W?6L;HqK63@){*BWQ}(Z@yH{&trVkLI$}MlGLLwUPNFlv4gr zSBXzn%BY@BoXvI??HDK79_}Jd+BwMAMQ(DT#9o?oc9lo$(-oySiEoIb#LjS#4p&-> z-PiV#aJr4`dhRAWR=LZN55=(#7bg!KF_D=zd6pe;Nnj z_{9L`K9L>f_l`CSfTxOnM)eT*uG4V7QUfh}G9DW=Xl5OVHdY#}ZW4$wD*`cK3BRt& z^N#$(oI3Pku+J8uWG^z8wIc@&BqR_`#s=a|`2d_N7la23194(B|GvKlSE|q_Hb8?U zo0 znEOnJGd=nBUDn#jC5i|6$dCL!&&4>Nv!|LyVM!sqCEa=Mu=lv+OB7;Q$IB$gvNeQ% zH;L!vEczcy`SWmHERRnj??L_et;8J1=2y%msI^h<|F_jIUd^1Ne>v3BKjbgx2Y zk<9OR_6t*cr(+(^hr7GzYGhAyacDYbkblg&pN2he)A78X2?6Fbw97YP*PApL1DIzz zpFYP(IyhR=En~|bXlF9WuQ*rfV8Y=L`XD!^W6W4O(!LhpFLJx3^5K6D(%Uncp=o5V z?Hn1$7j%;HoC*4xhvy@iCC5L@38#-{0Qr`qdH8pI9+EuB0P`G-s!jjNJu<=Uu~yih z&l&D~%&SlLBU#106$;RgU$=GnfRF=ZhhFDnCv&Q6eJa4^HF=2Q_nu`j&!lr@uMs7q zz4YTEy&i2^>2+PVE=6^0PfD2Qg%rnSF)5R3W~Cgp)+N7PH#xjOFe7OczOQzkA0q}$HvQkdba<4k|@S7 zdP-K2O^izr7uPr$ra3GJhbD-wU6PDr?ZtsEn^_e%jIxBD#y4;EQm=)Pwdh3IQ9VI?`XtK73WsF0-6450Gf6&dWp9i>du4m0 z=vNpdrqOXJ;U2S3JtbPqArmv5dDF2fY|Kz&RCO0jt)pV@sw;NdxuMZn6+)Y-$%ZO% z%2tgRCLLl$=pw#U3?`T{%Z{-4)e# zt8jO<3L|T%@p%BV%JeGSo=8`CunKjnGV|Jpy`a6^zugXl`wQ;VioE5`Yg zgGLDN=_8q-MZwLGNqKH3wr$J~rS;pVAsLgfV=IdG%FW2CGAG&1@((iqijKp@xSnfE4ye5W`g7zBmvJ4)bKL{1XB^yC2V$T{-Z@K}#`D7U%G8b+P*Od(n zxc{D9B==zdeGRthC@uObWydxL@jj%I{9t?O-M~)9t*(-VT!&5U!ma@UIocETqdZ~T-xC2pJz!=t0nK?;KGq7u7_L>`y(L=16Z#&R zXv^`(>J1q=t_SX%Vo!QoW_Ehg#d@XyVSMi!m2m!T-d%deDdovqdWUaymyhh1`TMR? zW=S&7kM!={{V+9wLtMTwm>EJ^X8s2f8>^hraX@mkDxVD{ljO)O*o`~0ZB6grB z`f%=gaLo(jd2Mo*us@|~1T-3YdR^)Idq<8iAQP*(-ucffHJfvS%Vs^?MrC5<`XX!@ zQHb^ma-PZ}JXp!T3mbYP>-CaBm%GTo$(?0nLu)zmKq+VEDrNo&lN_DT_3uMElsPZ| zL3iY9U!x4$Jpuc+GB-5X6ZejK!pFpH?h1E$1H*CgGIP}yhSTjIhRIRkC~n2;!+SKf zZzk$A$;7kROw3%Ii8NobGY`0yT1`G>E9VJaA>7|HN0i^YTVf}nL#(CjM<-dlxtmPB z-9rwwvnB^(lEs6oBdOR7CeA3+%*|l&+$e8uc%YY_b3GZ$M;0DvobAaPpcj5WLhl#n z$O1AUuQ!Atnd{JVrR>>hk%=2z7Y<#MiS|3WMl{bv8F`*R2XIa~QGg$_il8{mIb?Ma ze7dpDukFVER0ruZStU1W^EtYpl9cu;3BFb(a-UA~6=8Um&3v)1%u6Td)Mh-_v`(31 zKgh*?F2shpg$QiV4AIH-TD>lW`SAiQe3u~ZsfjXw0=>H&!;5bwN&ECT86D_=OLPE@ zUa!K7cS@vGC{gc&13C@}z~mi)$R5S9EGH2Di^*ef?;IVY#npf5V=Q7H-&_qoa(o-J zkvRfU2H3R9#qVS2dYwY=e`}5#+FbPKS^4oM3U!8-nY`o-nq(`~vR0v<^GgzQN|L0f zxkgrmC5s=uz)P%>B=?FVUM^Q5aIq4NhC85Xej$s^=CUrMpkCy#<>zI{UMfPlhLhawt zOnrWeLOtd_om)2)>ib`kC47KZz+Ql96B6X3w^sHflke~Eh#ogMf8{w~$!)p_SE%6Y zt3n%&?RB4%FYw|xAI923SP-1Z5N?g-_&XyB-4^gOSu?lcz6SN*(6{vqGnBvOV9hQ1 z8Ln`A^fTaCqa3W_pRJ}p>VYHKi+&3Ao^o;+hZO1-YZ64wzJtrH$%4?~w3EI_^V4xM zt_l5vEgexWUx|i=N@&QR`cGHkY9{lyQv&Jp2|&Uto{=mddqGC!YNsTG-_+vYM@i6c zOo9jR-Am3B$&!nynjE+W8W1zYfV_DIZ2L0@Z^;in?XOTz9;i^aB8xFNi7rAqr6$)o zC8s)TrPh9pNVHa3F%#q;*JQb5uEHCI5(~bNBiyURRPQd($0%WUH;}tb)?RK0BH$UF zWXAd^AAXY1Yy z^`@N)wQmaRw&xV;_3N1-IzLh7Ha#UN&61>WqE-U>$B27@M(n4l;2Fz)hduV#USN-T ze2%Wnutz)2|2|pF==?hn+r|fAKiJd28qQ44wW&Vr7wE#e%5+|%i|i3yLRa!~&S@*j z-A^`P1ZyXM@;MsnWI)_wg}OVL5Yun;R*qGuGnXsW)^xU=e$ZLE2C8JSuB$A&++D^E zR!UrLNBMljBnmK ztHZJAd78Zxy-~^E7dZ~ScaZ)8U0K_+mwRH8gx<_`er$%=Nw&7_e;G$^X5s1=%_j=D-7v$hI@Njp$o=%% z3D`jX-GSU^!8doDSnr7|4LqQs;W&2xY(kr6JtLy*uFL3Qa9@la?uSak4u(h}^Qx%~-dnlf0*r)X+ zRT`xx$m3V^>PbAWO@hR8uW;d>62ps`-gWm%+nB9O3;Xo}MYvrO(4%gpb z=_g_R^>uFp#&E2jZas8f7!~pg6`TE&CJy6ILBX) zO_1dmQe^(ec-gr-Nm_5#irEV?1>=;M+nBv?85+;!!+-;tO#(Oka*;0#>ZCTU)VSuGI`{?z|Q|1`m@=y*lS{3Sv zt?11qlfRDhMh;m^>vd#M|4EW{os;EeH4XXqBw1GX4+-0!C=E0Y7`B+_8@Bd%)RTKk zGL5|(Fb{wnW8Mw!0du(q()%OQA`sql*w3+BgExBveLp#{fKkvu89iu_hzZGikS#M*w0a?XQFs> z&z@YOmHwR^Fgcf=hfzw@e`OC%7iJiQsxbOT04^j1BDr%AmTwQj`z<`1XvBSMH7zbL z*P^Bw^P2eFT>Hv>W3mP#V+;u3XZo97YT;*ky`KK#RXKE(Db$Jl3|m|j>VenDesV2l z#Yc1yFh8DeY!^;cok*$}3tI6~p?zNCy|5BMdXaXYd(K|Ms{>1(TI7Qy= z*2VAg*_{3|=TPjN#rn@h@{C@V;-oE;>L2Mri=fBNoF3Lk`6!!WAr0vHy4l1X?T3e= z7X52;m~X3eX)O8V5U=RmVA6-;%n%)HbLbsw-c(%X{*YJ9an>ye#aI5GKPTm*@>@qK z@F^mOWRyA`F#k= zn~_^Qz&vYbE4g#ER9-)EgH1^YB3oqOMpNbm&#)4;S(!Zi#5~_sA<(LHh})TmgZ0{w z(=C;YeO&o>55=w3{QPb5v1vj_$)(rq20fA&28AMo{LW0Pd|VjVMzlFUWl!mNY@ZQ| zKi26mmfzpIy_M{#&D_L{{WF*`n~$4;?WO0WN=aMJ+*scbyxfz42SW?kci3KP-~B1$quenp zAQajytG|x`QluiYx z_D@TBv!zV#UUNex_tuqnbeJ2P2bZty#4n~)UM(WOc_b9>>oZUiTL8n`Hj=rhR1Pyo z_zZbK$8sHNt)X*wcMJKZG>WDB1ZFRWV*fgFdDRQhq*rsf)3QqX)5{i5zBT$jxzX|D zJ-@e-4%^CQTO)VmKc?rg7kQ<}c^G%Cl~f)tku<#vR+3xP|J0$$bzaXAE#zxdg+w3Y z_2K>9-IKY%Va!M>q&M)FD!E$U4Qbm$(cl?5xVCxB=V>879xHeb#(wi|p)gZt;6hnG z!h+h0KkLeiCb_{jC=^Qzb+|-NVsa-7c@bJF)A-!FaBVi1&xs$setU;n$evlH67|Lv z3x8v-^xv#`{*ecJuXb{O2%k4z=Zk$p(cDjmUZa_lJE6IF`d3PmnJ&otH57GvGgtSo zeDoyOIX(HO^me0va2oT?2V`I`dBa`{n$a^;BHQM><3MZfOCRYF@HQWdhFQvc@@1cr z-Ep!uuTQEDYmNEnIG*31_f3WkoPZDSLZJMl9`0%D!IZpowv+aEH&o$5(Qf zpRA;k{GiuS=0X2Xj&*eg@^~HElILAfy-HdIx#CZr6%9{kem(2DCFp6jEFvYO|CFK56!z<*xmn(bw z$V(~v^fKc5U^ zD_L-;Qqmi`Lwg_uU!Uo4rF%X`S+tRx4S&e_!){2~Ob&5eIu`8U@44DReDg~sw9pN| ztqI1{Z{#{T9(KIfM&8dV6RTEkyjP)k#_KaCyZ}d-PyNfy3VCpp`R}Vj;a!9K6LQwG zw=@=+`%|9noq*(Y=A?6++&48J6Tdc<5b~JK`qA6lj``6CbZCBw-q+<2gy@h1we3y}pT+xSIw)(LSi=WdI+PJj@fBGpsFS@~b96gnsrw+7Y zj?=0*(bG?Nn|uoBt$Q~r8?{1>%qobKSBGs;*OMN=iwP+2OP^o_y?ftI%ChxzX*0KU z!TJRBbSk6CzSZNk;482Q%91}_Krqt-ogF&nZmZGjP&PsB)@NzA=Hy@7q6{Qar)%Dt_^ z+T$m zvKBL@PTA8-@6Qa*L}WB$e)oAJ5{5^URk26hC1!QzkvIIFg^f`r6wE&%zc;qUYkxnq zp?`Dm*lY~(HPMM2D|3F>ApV>$x-8P*9M`i?xo)&{j+OLjHn3U8vjhH~#tZrVmquhv zBRliS8tuu+ZnoB-n?*Jzg_)o)h$X*l&)zM1+{PwC9`NtA&V*gHnOEDw78`E)qUKxr z^_V04Jlx1W_7h^A&ihCnP|JMV4M&*=-Q9%m^u!&e$Fp;cANp@6hedwF+fJblJ)a<6 z;kMXr>5Eh3w(d4z4s|yZq;a&=)Y@U}6@RQrqc?L;7NXu5@nzOAiQ7a^Ty^S;tD=1r(bd+dwDN%7tzcJuL;McK~r+RgZH+%bn%DP5;`cB(f=^igmujIem0la;W+)3JvFG%XVH~oV#Y+Yy!Exk!@54u zmeFf@F$?pXnvmNqQc|+XSVj9_O>839{n>bU+K6H4vC@Fa)wjMN=z1OJ!gsShNe>j(0uf0z(|EI|tD*kjlfU*z%c z`)BPO{5#f!&<@dZj^E#Zf#W23-fk!8)#Y>8NEs&!_*`w;&F}L%4Dt9c&zgMe&Uo3~ z#)e)Te|#O6fbHG+d9IppGBsM>IN37a#1CW0^O~me{S7wZ{^2NTV`jr_4qv=ln}9<# zaxf`}UeP{rqF!u^zgzlZ9?$3c)*wghVZ^DdXmKQmK4*tNoUbH6YskW)eI_W6B*>w6 zT_0%;`=bZ@V@d$?vLgW%x;P{APpNPkhPPCSqn_ zHj3XHu_h=+4viwWUW4O&3g;J&Z(CCT|NV^fe{3DN*U~CIa8prQNX!_g)CHl=>BI8U zGoCba-qWKhJ#NGKbj3u4Zlm{{^oz|-rCn^kGCj6MaN71iU#D9-P1QZC`OW!9N<@0j z=vB_6A8b!g+-{wI?(GgI|E7(dtM5s3-k4~WzOb~hbHl^!(yiz1PT!Ms$EkPht+YW? zR-_mD9!RToe$=4y+E(eB&8yQ*Rnh62<|Iisez_MX%Z3LDa>`sQ(f`JabHjL9;=*TV zCiA3w#misr$>N!wC~ar4W-&EZtY5{+t;wvb&}VyiTat`4Pm~z;jxHILEUj7hJ^V;3 zE!w1r`ec%Xm&Qu%^BOVtp?}~}igZ20Il?Jfj?l}P$KKcc(Mj^;gI0EJ)X0!Dd(`5& zvWj)$&sGj_Tx*Z%kL=NLs{@{Grz^lmg%4j@&u+%LaXd2z-5v1ip*>*ffOokn^ir#! zIH_b7HGiI7fyO;m_&HpODJu3v-e+HJq&*hsc#a)J?s1L^s~f3sfc5#@mG&^>*@1!o zO(!0pL|Kaxm z*x8il**pXJRG)o~O@gpy66@Hk^?O;f{(nCZgP#Q;BR&8I6KmTGSp%CEgdxuZutY;9 z(uU^)|M;Vc1j6dGKay?+U=n}-71k0C_n>d!8}lc~3_nz9Fe!~==1483AJ<~|Ff9&r zWNt?X*6W`!k6Nci!l)z^E}{qEr3U`f=-~0-dA73#<0~{+#53tg2Ra;j(%+M=g<=MM z*!;cScwXI@XEgOvHHg}##lyzzC+5#?8lnLX(%Be9SH=K3f>-iFsNwE2MdIT+8H+Rwk~rB3I&JI8?Q`8kMV-7jtw>ukkv+DGITC z=GV8EIZ7LuMdN+WC6!p@E9H+<4sxrTqm=zr$|&Eiq8Qv&j1G=sJEezw$?YnqqwOX9 zjICVn)msj>u$QG5nXB8Oy`*%v5vxN=IX2c-e6OgOziuxf?dfkkY=)+{E2VBbGdK@4 ziG5I|9I`OU!lMeLvQF&!O2KuN0#j}1q+eAbdlpn1ABQOfM?O$>+$QPH@=?qfZ{3LF|#J1{209e zA3X5uH}X^8=$YHdI)4*S*04Qs@-GjJ9>5-XGFF8TJ=ovF9P0fO(Cu#zSd(p3O`@mn zEzbyM@a*>T1oXP^fyh+;8J)ba=CTK3i#_nUS{Tm140v7z4(OPndN}fxw z)?GeM4<|AJs$F`_Q1Cp*s7FCfy5B4_;d3+-H8<;_cW0eEUys9{dYZ3=!n|gHbm5KiP3}*PUE~d;t=>$3#SL)#q$9`Hba$UXk7@R@x#2MyAP1fW7YCY0T z%;Y`F%<4^gtlP@-nbC##I;0RD=7p%bT8Q2{@=teouHB>%ezObk-oTs%o>eIKk(D@4 zo+`V5{RV|dj4yyW&v<@V@q8tj4mh4;+;u60B7_;2WEe8Hk=0^PY{N{Rb2MO0zkvCL zEei22x)3k76yomW*AqOq?qe$pGVR5GPJ5|t<0$ikI!mhyw$fQ_ z<>OXsW?pm@(-d2|+m$X}AF?W=QjA7adkg-Earl_j@PVZ&1p@SB`Sj z&`s*S?kcX#b?_~$jB>@?C@Yp5B`&BM8hlkCd7=X2=yzCFsldfd{@fP@ zdS0)R1y8D>wqKRpyQ;urf0G2|Gq19`N%F>#AxTsq#-9J1`7?_iC}78Pl_RW41^+Ng zi+qz{0yEw0s=@cW0=?cUkl48z4nOC6Gn?mg*@iIEKi&t>51Eg^dl`M2ie36^MxNUps270|8~6^f4)9_@I98Au zJ~%53lYZyB!}rQm%>Ht+l2=wT7siX{Nc_s_Mn~#d=7sQmHfzSd^vE#yC(+r+Gt#>J za}`#4c=3JOxre@&s7$5;y}4wET^;G^C}b^XND=2?GKdN~xds-( z@+8ko=M`Zk-z%@m0(?15#&;9_jw|WMn#$bGxrOL-oDN58x)+xfVm{y1@iBCv@Ew}B zoea|gx@~F}p@e67mI?GZ7V`buRD>O+1u%Xo;JT#{-|k*_o|bW9VBO&6=@uR8JHHun zByC_F!@y~c&ZgH-YOA}kC&Ot(<&pHt`EI(XBMRpX|L}DEb?5Z>8iSqoZg1q=t;Q!O zyFT8RzFpYoJbPtWTD$Ci>FdAkciQ}_{F2uYf9KYk>gfYJ9Zox%G%9`D=OMq*VOs9`y%hOmf+|`O< zxmJ`#@nTMI;~!5GWNPa;$@q{UpRQ=6-h7P&ZcP#U+wl?_c}hA}Xl0)&LGJuZ-%@_E zlov3Un!Ph``y|Pmg^4nL(kV&oLD%C&t!xX^%9bq&($$6T?!)8I6JTp#DP5(_L$YL>``sBBWCwf@f?(H@N`Gy zUsED^x&!)hU3sFw5&r&kh_|MTX}3T0y~r=-kuhu&gmwGrA9=})XtFqwYq^fQ#@-dy zLSB0DpDxV53}7a7EL~E+(A6}NEaYm|Nw~+D7{T+a!Ss`5(B;&EXKZ5v@k$+p20sH3 zcZJ>;{_N`kK}g`*v-NWJyIc;y7p_T9dj()@IrGWP=mFU1Q*yrbwgfXA#h>Fu-V>vm;Yz0P6=UG;L>ENo%bJ3YvtaRbm5G_{h zC(~HWUX~rq)vL`MJDzblMY7+`itD{o^fYp<_heBH(rfbE($|1a^$hss9na?avqyNm z0opuf@m(d zfXnC~K&J5xbB#V{Ad+Lzu}*q4I8=y=TFmL3S%~S&3sKXO^LWD|EX%Qz_AQn2u)n<= zZrELJj$XoRBBNy|>)UpfgkpPH^Q61ny5cCNFZSYc$Bb^@>WF_qZ{-=2jH;`ELyS>I zWqBd~E`3rzJ>WFJ3#I2gVKjK6zkfJ;%EM97Cmi+2HvU*kkMCkKbBF249YIcJeI}Ov zP39r+GSubt^rjVI4zG>#u0k}NRES*xMRb;a!WHMPQvbfa?7Q7v+?V#0_j#R}wc1r~ znbSF_GsEOo3j8FCdh;yvmFJKR`Rs`V_6amN?1=~?Gudi+B4v%||EwqNC(=t?7KUw) z>Hj)MkEKmG{^VL~ds-&04x$@)K_*OOL_V>P_H$+der*WxS9aFY3$L&uxpw0Pmm9WQ(=;XLk1 zk7Ylys1rO9Jv$6_GU=_H5QZ6Ck7gBx<4d=7IL32?iL{ROd(o36~LmGqbwZMLzb;j%IBdyrCWQI94c^>plCCEI&X%BE33q& zhee1CaaiFUgLfk!}=NjXMjTbaM*%QHgbbV78mLn9cG+~IC8itnlxfa+> z|M6%&ZXBi)jnB~F1DP;O)nkV_9hzLD_Bu;0mupKK&X?KkituByMsD~g%Rez>2cxud zwMr{RZ8VaT$Ns`oDkRrdA*Glsn4c2;*Q&68FkQ9Z$;5>PVdH`TWVH-Lg9m}=dWXGq z9B&rQ(V+JS4K{bz!d=K2jLpT~rUs1OnFEVw20Ru6{$SSg;Qh>2G$_=I9L&@jo~5g1 zk}bH){`iZ@ViTP#O~^C;Rlw}deTg!5kVc{xtMKv^^QNb&pdP0}&N=ezI(t+MCF?Md zJ?%RKvGx%A6ggghnoaIuJe{;@T2ww~AK`2*R<9;+N#-E?qyZDi$VK)sVD)ALT@tyN zP@Ic-%uoL5&A#_Ug}Q^cnfd^|Tb|6!w5^#eNzCbVd7+`_kB-K*%(k$Mmkq3WDF5>f zdO2ckA$u&JaGtBdyyp_KohkG&HV#6@D7vI}1R`%~AY6arp8T5@rCA);pR;eVDL>m` zEjraP!0JX0mT^qA=)$~%6S+Jmp*N`;U6BVA>QW7Jo<}gZlZ?v6(PnDr2T8K!c#1gC z1GeifKMUPo+nrLSTYdJIrZU5VETf!bmgzrTQ17@BBAvDHeqGx4H4#$44O8i`ES$VGb5?%i=fljZgZYp+CDi3&r>fNuQ| zh!LEFZ8#SnUlE8uKL(com=O&fR`xpaV zA)HI@(2bv9)FrlCD}@Ur9xfN*-Y&->y#AqN|Zo)CEQIKDXW<%zL6UFP0Jcn zA9|dt+2imlB?kSfL{2Le`p*c$x2J)a9~ubH1_7w;69|=65Dc!&)=;tEfKJan%gLqK zlCNCPet@?I*w!+j*Ec#V`FUEPE*=90JneY85Jq|P|LOR#L z_um)5n|sSnYYNd+$YR1=3e^M5%SaAr!I*s!m;6;zZ!hRIy>q3$zEE2c9g<3-DO9E z-qORri~JR-z=SIbx&X*DZdc&I0)DQm3iP$|f_^AJ2j{L|!kJ&3=??#|^yzcoq&fhVTb zqLVR%{iS&xnAC6*qBwV*`N{mxap5p8q4WL#uhn(t8*)xJ>z0X+LF6m>&mZU6yReqr z`QReFp2of@&SAHovuBDuR9kJyq6T-BX=7C4b=E;f`1F(-t8HXVGe`E7SBD3x;csSx zA6Q|AR*TGV@Od@V;~sS1HV;%+dm`tm2mZZCmT-nARt^qFx3Szex`$z+MK~s&V_zJ3 z)CqMnv27?_zB}}oevb8#0zI}Bb8l9`9?5fs_|$`Sg^WVjb)bKFD*cSryGaX=E)u45 z6zO0mbFV7pX-)PU|6!8Sbw;sfy{pwe_VdOX#lS2Dmt0Sn|HdA{treY`#+!?C&sGs|n~@#4517i+Ok?tmUieKWCwpRLBbLiEVwzV2Wl z0QR)yvVUP5uUYpLX>OG$JsxXic#uY>o{N`X_oawW8SBWLC*+a}Z(led;krFt4oXD! z3qnMTAS_goq2@b3c5x8Cer26FgEdypTb8f2_)PDMYYcnJxi0oGvOi~C4)mMJr1i^% zc~%b27BT0UoZj^qh1&3t%<_E`_mXC6S7s`2*qKOvIzjquO%lI#$)ao>FLPKoAGnog ztx6TP=5o*SL50Eh9Z^1BiRnQB+=BL+B`Ub#rWB_(?|4T7=~)U$STj{Pl3 zMm*69GqA+%Sd#QVn8;i*tz6&hfRNYh3#j1UYAmnQXFIfAt;C&QgRuJmJ&^%q81InT z1LyfHj@6D@6#mqr!vrmQ$I|Kkl>3rxNoc;!z+S8zSo5E8uUIoK%f({ypWiCTo7083 z;G04nd`O|zJW;4KACW2ioFpDONz!HZDM@XYET^NAq_TdpqzrSw-JvS1w@@LE=L$c| z>C)}tz#K9<2jjSZ;vQ{udLT*z1Mwm}2)4g#@!U;|9sEk2lLWiANm%qvgRu(kUFMLd zTw_4kW4hpbaZY8Q{kVk+bus-xy{nt4eYwtX{Hai)aIw8 z`MVVP(998%2n6G5t*aic$iwziJ&-tqn`~AlmkQiWq8GXyKrxa>svO-<9m|ovA3UvbK z_?u@E#r#T=MAJv{&@5Sc=f=vx1xeDOM^{Yb^BZi=41?=R`2Ix~gtrQF`UIivSgv`h zabL@G2+N`X4CX#m-+-A+g&G`vNG|`a1~a%mn^Zt9wnh%>{KNd~Xl6_Y(7${>2k-V7 z@E7OuK=uZ#B8O^|&;QLizUm$S`G5M#7Cmn*_7&waVuTw`HVDNDwGIa&3g{?qCD)ez zkf(tzm~P2hFnO-Y|B@@LYc78=hp1W<^MxPKi+4N&Jx7o?iEbo0&de8X=8CbAA!J`O zaC;v6v(?RIZQJiMYqC2ED?_nlw+_~!1yCMpB^}j2rA0&XJAVYjvXLHBg2^RqvXqxe z6%s#^yxW;z6fM=^tu7z?+gQrR=H;UL;DT~Z2u>NvLv7DTMvFG`g88r?tlhD5YzT6X zq$BG&y<->2VKF<&a=Hq!Q3(09z zB4NzoJuoce||B!o)w{Zl*pXu0r{A@ubo)d{V9Q?-B3qIo@>Z| zc_aB~f7(KpEGw0+aV~Uev5$BP^II3^BmFtKysKpr)R7*{k>n!l>oD#*J$H!>rN@zP zGStTv_lI-un5V-$a#(F=TgkVRrF1>g)7LD7``rv2<8>aHMGh#aLi&}v0)3b-Jd=LC zsQ|nM@z(ieTo|4zkeUeTxFjENLeT&VQFVyl&6UL!g?Q0q@uOSZ&`*Iu9-r zgP!+yZWxvXWx#wHIacrXqT5j^*QU_-Ff0U$_UzvxzxF8JLUu)zNbxZ~hi^l0X@5GN zEg_$k+C+-7OJuph1?`JMaFw-7wH@!TzP&h1E|;e*-SA^}DBh97ayZKSmEM9GVL#=8 zxMGe)DB>!0C>>USX!;h-pH)ixTJ%-FBe(040ayP1?|)fJ{nmUh_<7uHLa{iPT%J=t z4)wE;9hK#xadE|XK8H?&=-KQ+FXXOvQnvPo_%a84RCU&CU+It?mXEY|%_M~U;Q56v z5Z=e9yuZ&j@OiLmD?WcPHz3socdCN1^q~%p6?x1MpvRLr@2Y(Mp4lNlFu6;I0z6&Y zLh5uV72O9n%#0?Nx`!1X3xFTZ% z{eyfCTb$0v)B7D{pl6wc@V)a42*J%T9o;G9XX`hYYOl&<8M)56iHT!)fc`LJkW zA>a4?l;cZW*%uswu1Y?K76nL2wGe~%cTs$!kCohavspUyO=E6*{T5Q$ieAwHE*QZ3 zHK1Dt8u2;#`pimBxK&6QbFuX!L-5ujgSo&3xX4`fho0Z%Qw=wGKMg@oa^-0?3-Gpc zGx=n!l;~|PxXE!TEmnsNa+JSaYfBGysf7IMib8UW4?B=6pH83b*iJI`LaF#H8;6rK zLNSz_=E)j719)~qru*Ar@2d@H=a`7ef%NE2GU4FESb0=rjn-#;;Ow4={+`Th&LU5@ zHd5{_vO%99AFd@5(6b#KJ>>rU_eDuI`KBw|0}&dZh;a$oP`oi>L&OPb{mmY$-;m2= zO?HfT7B21~514yGjt{iO8s?b}dY6Dfi?b1Nk(}L}IH~EuTwQW`_y3AV6LM!~4w|r| zUbLjA*kPQjAN#`-Vc8)Y!Do#~nHVW5yduZLtrsdnBS(em1ipjr7YzNl!}~^e|(d^5uB^z9$>Qt{GAB zYmBT2vBu0dKDb|*fZxwQ#5?kaj-~O^ z9C@xWEy*R#GGcgmtUQjl#l|{*So1Ie`+AcznruXmFDGT_7v^8jA=h&-0aq?$VIV)x zP48oJ|FjK8P4ht+xzSNKbKpTfD`z|NyZ4bdyvbbMA@pYYXW`Hh6FR%c$mh@2^c4DI zbO?J4BeM|9>pbvYv@F=h`+Lt1e|od#{UjTg_Lx|kkCA(scDQ?B12RGq@xYC|LVFYL zS;a^n7hCk1v;ptVCh(jm3tPLN_-pTqQ%)kCCM#9Riah>M? zD|{2sdVLl;yfWhBwP@)|o^<Ybw8KeRLbunWRGvFnC!*$tEGRyZ zd&-KHLvNWAO>U&eUkUiUnf&QE6VmEOi4F6VBZiVMo1K7vR%bEm*8~r8ZSKtJzOdE@ zwO1#gY%;x&{BzGFMN0v>zp_()XwokcK7RC1)ns3=f&5^o4bM(|@R*!b5qY#b+nB#R zGD=E%vX^ra^K*-t4a&dQkLyNQ^d+Zx$QC;m`XN3#f%~K!JRV@g_c~FM;bI5x&i+`$ z>lwI+Tw9J2-c#eGjDPOC{0(@0Gy#EmS?m#IZuR;Y+4jN)2J&AIxqmv?HwTJcMs$)` z8A@*SSdkBVM-otDeGX=?Gor)2C>fSwgJXkykvKIG?!J7^la1KZ>$ps!7xLaLKinM2 z=Qfet-$WC(I7N!jB0Dth=8qC`m&xS&tfI+#21LrY-)%6kg+D(1O5dn18|$B$aEhML zPxL}Q*hSysjRagP&qCwlCcKywCGY9WdvMAZ6IJAJBgujCd2<>RCy&nAqEYY$JpUts zPM0iP{l$c3+DNIk+ZKDmeKF0FT%dVMW zlB1lH>WkD93Cxt`bIa$g7yIqPnRo2;m3hs)?{n^v=lyQN(LbZ*G(Cgvdwkj3oQOT- z?0&R0K|4KG_8M%+j_~^LOhCJJ~esvegDX&-uX1kbwLHe6I4C zul+butnS(%uFxMotrF3b?{9;P^j#X`Wbj+wuUKE`cpYk!v!2nCwZ;e0;>PjZa{LAq z%}>Pkt64bw$%wS%XsK&qi~5QFP~Ru#+lKkS_UN_Hhpy~+j!juGe{94vn^^hT(iUc~{or#V5g)r}all(FLERR,"Illegal fix langevin command"); iarg += 2; + } else if (strcmp(arg[iarg],"halfstep") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); + if (gjfflag == 0) error->all(FLERR,"GJF must be set"); + if (tallyflag == 0) error->warning(FLERR,"Careful, tally is untested"); + if (strcmp(arg[iarg+1],"no") == 0) hsflag = 0; + else if (strcmp(arg[iarg+1],"yes") == 0) hsflag = 1; + else error->all(FLERR,"Illegal fix langevin command"); + iarg += 2; } else error->all(FLERR,"Illegal fix langevin command"); } @@ -155,6 +164,8 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : flangevin = NULL; flangevin_allocated = 0; franprev = NULL; + wildcard = NULL; + lv = NULL; tforce = NULL; maxatom1 = maxatom2 = 0; @@ -163,6 +174,12 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { + int mem = 6*atom->nmax*sizeof(double); + if (hsflag) mem += 3*atom->nmax*sizeof(double); + + comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); + comm->maxexchange_fix += MAX(1000, mem); + nvalues = 3; grow_arrays(atom->nmax); atom->add_callback(0); @@ -174,6 +191,14 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : franprev[i][0] = 0.0; franprev[i][1] = 0.0; franprev[i][2] = 0.0; + wildcard[i][0] = 0.0; + wildcard[i][1] = 0.0; + wildcard[i][2] = 0.0; + if (hsflag) { + lv[i][0] = 0.0; + lv[i][1] = 0.0; + lv[i][2] = 0.0; + } } } @@ -194,6 +219,8 @@ FixLangevin::~FixLangevin() if (gjfflag) { memory->destroy(franprev); + memory->destroy(wildcard); + if (hsflag) memory->destroy(lv); atom->delete_callback(id,0); } } @@ -203,6 +230,8 @@ FixLangevin::~FixLangevin() int FixLangevin::setmask() { int mask = 0; + //if (gjfflag) mask |= INITIAL_INTEGRATE; + if (gjfflag) mask |= POST_INTEGRATE; mask |= POST_FORCE; mask |= POST_FORCE_RESPA; mask |= END_OF_STEP; @@ -258,13 +287,11 @@ void FixLangevin::init() error->one(FLERR,"Fix langevin angmom requires extended particles"); } - // set force prefactors - if (!atom->rmass) { for (int i = 1; i <= atom->ntypes; i++) { gfactor1[i] = -atom->mass[i] / t_period / force->ftm2v; gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / + sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / force->ftm2v; gfactor1[i] *= 1.0/ratio[i]; gfactor2[i] *= 1.0/sqrt(ratio[i]); @@ -277,7 +304,7 @@ void FixLangevin::init() if (strstr(update->integrate_style,"respa")) nlevels_respa = ((Respa *) update->integrate)->nlevels; - if (gjfflag) gjffac = 1.0/(1.0+update->dt/2.0/t_period); + if (gjfflag) gjffac = 1.0/sqrt(1.0+update->dt/2.0/t_period); } @@ -292,6 +319,94 @@ void FixLangevin::setup(int vflag) post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); } + if (gjfflag && hsflag) { + + double dt = update->dt; + + // update v of atoms in group + + double **v = atom->v; + double *rmass = atom->rmass; + int *type = atom->type; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + double boltz = force->boltz; + double mvv2e = force->mvv2e; + double ftm2v = force->ftm2v; + + double gamma2; + + for (int i = 0; i < nlocal; i++) { + if (rmass) { + gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; + gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; + } else { + gamma2 = gfactor2[type[i]] * tsqrt; + } + + franprev[i][0] = gamma2*random->gaussian(); + franprev[i][1] = gamma2*random->gaussian(); + franprev[i][2] = gamma2*random->gaussian(); + wildcard[i][0] = v[i][0]; + wildcard[i][1] = v[i][1]; + wildcard[i][2] = v[i][2]; + } + } +} + +/* ---------------------------------------------------------------------- + allow for both per-type and per-atom mass +------------------------------------------------------------------------- */ + +void FixLangevin::post_integrate() +{ + double dtfm; + double dt = update->dt; + double dtf = 0.5 * dt * force->ftm2v; + + // update v of atoms in group + + double **x = atom->x; + double **v = atom->v; + double **f = atom->f; + double *rmass = atom->rmass; + double *mass = atom->mass; + int *type = atom->type; + int *mask = atom->mask; + int nlocal = atom->nlocal; + if (igroup == atom->firstgroup) nlocal = atom->nfirst; + + if (rmass) { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = dtf / rmass[i]; + x[i][0] += -dt * v[i][0]; + x[i][1] += -dt * v[i][1]; + x[i][2] += -dt * v[i][2]; + v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); + v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); + v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + x[i][0] += gjffac * dt * v[i][0]; + x[i][1] += gjffac * dt * v[i][1]; + x[i][2] += gjffac * dt * v[i][2]; + } + + } else { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = dtf / mass[type[i]]; + x[i][0] += -dt * v[i][0]; + x[i][1] += -dt * v[i][1]; + x[i][2] += -dt * v[i][2]; + v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); + v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); + v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + x[i][0] += gjffac * dt * v[i][0]; + x[i][1] += gjffac * dt * v[i][1]; + x[i][2] += gjffac * dt * v[i][2]; + } + } } /* ---------------------------------------------------------------------- */ @@ -477,9 +592,8 @@ void FixLangevin::post_force_templated() // sum random force over all atoms in group // subtract sum/count from each atom in group - double fdrag[3],fran[3],fsum[3],fsumall[3]; + double fdrag[3],fran[3],fsum[3],fsumall[3], rantemp[3]; bigint count; - double fswap; double boltz = force->boltz; double dt = update->dt; @@ -513,7 +627,7 @@ void FixLangevin::post_force_templated() if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - gamma2 = sqrt(rmass[i]) * sqrt(24.0*boltz/t_period/dt/mvv2e) / ftm2v; + gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; gamma1 *= 1.0/ratio[type[i]]; gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; } else { @@ -521,9 +635,9 @@ void FixLangevin::post_force_templated() gamma2 = gfactor2[type[i]] * tsqrt; } - fran[0] = gamma2*(random->uniform()-0.5); - fran[1] = gamma2*(random->uniform()-0.5); - fran[2] = gamma2*(random->uniform()-0.5); + fran[0] = gamma2*random->gaussian(); + fran[1] = gamma2*random->gaussian(); + fran[2] = gamma2*random->gaussian(); if (Tp_BIAS) { temperature->remove_bias(i,v[i]); @@ -541,25 +655,20 @@ void FixLangevin::post_force_templated() } if (Tp_GJF) { - fswap = 0.5*(fran[0]+franprev[i][0]); - franprev[i][0] = fran[0]; - fran[0] = fswap; - fswap = 0.5*(fran[1]+franprev[i][1]); - franprev[i][1] = fran[1]; - fran[1] = fswap; - fswap = 0.5*(fran[2]+franprev[i][2]); - franprev[i][2] = fran[2]; - fran[2] = fswap; + wildcard[i][0] = f[i][0]; + wildcard[i][1] = f[i][1]; + wildcard[i][2] = f[i][2]; - fdrag[0] *= gjffac; - fdrag[1] *= gjffac; - fdrag[2] *= gjffac; - fran[0] *= gjffac; - fran[1] *= gjffac; - fran[2] *= gjffac; - f[i][0] *= gjffac; - f[i][1] *= gjffac; - f[i][2] *= gjffac; + rantemp[0] = fran[0]; + rantemp[1] = fran[1]; + rantemp[2] = fran[2]; + fran[0] = franprev[i][0]; + fran[1] = franprev[i][1]; + fran[2] = franprev[i][2]; + + fdrag[0] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; + fdrag[1] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; + fdrag[2] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; } f[i][0] += fdrag[0] + fran[0]; @@ -567,6 +676,11 @@ void FixLangevin::post_force_templated() f[i][2] += fdrag[2] + fran[2]; if (Tp_TALLY) { + if (Tp_GJF){ + fdrag[0] = gamma1*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*v[i][2]; + } flangevin[i][0] = fdrag[0] + fran[0]; flangevin[i][1] = fdrag[1] + fran[1]; flangevin[i][2] = fdrag[2] + fran[2]; @@ -577,6 +691,19 @@ void FixLangevin::post_force_templated() fsum[1] += fran[1]; fsum[2] += fran[2]; } + + if (Tp_GJF) + { + franprev[i][0] = rantemp[0]; + franprev[i][1] = rantemp[1]; + franprev[i][2] = rantemp[2]; + + if (hsflag){ + lv[i][0] = v[i][0]; + lv[i][1] = v[i][1]; + lv[i][2] = v[i][2]; + } + } } } @@ -641,9 +768,9 @@ void FixLangevin::compute_target() input->variable->compute_atom(tvar,igroup,tforce,1,0); for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) - if (tforce[i] < 0.0) - error->one(FLERR, - "Fix langevin variable returned negative temperature"); + if (tforce[i] < 0.0) + error->one(FLERR, + "Fix langevin variable returned negative temperature"); } modify->addstep_compute(update->ntimestep + 1); } @@ -756,20 +883,41 @@ void FixLangevin::angmom_thermostat() void FixLangevin::end_of_step() { - if (!tallyflag) return; + if (!tallyflag && !gjfflag) return; double **v = atom->v; + double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; energy_onestep = 0.0; - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) - energy_onestep += flangevin[i][0]*v[i][0] + flangevin[i][1]*v[i][1] + - flangevin[i][2]*v[i][2]; - - energy += energy_onestep*update->dt; + if (mask[i] & groupbit) { + if (gjfflag){ + f[i][0] = wildcard[i][0]; + f[i][1] = wildcard[i][1]; + f[i][2] = wildcard[i][2]; + wildcard[i][0] = v[i][0]; + wildcard[i][1] = v[i][1]; + wildcard[i][2] = v[i][2]; + if (hsflag){ + v[i][0] = lv[i][0]; + v[i][1] = lv[i][1]; + v[i][2] = lv[i][2]; + } + } + if (tallyflag && hsflag){ + energy_onestep += gjffac*(flangevin[i][0] * lv[i][0] + + flangevin[i][1] * lv[i][1] + flangevin[i][2] * lv[i][2]); + } + else if (tallyflag){ + energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + + flangevin[i][2] * v[i][2]; + } + } + if (tallyflag) { + energy += energy_onestep * update->dt; + } } /* ---------------------------------------------------------------------- */ @@ -869,7 +1017,8 @@ void *FixLangevin::extract(const char *str, int &dim) double FixLangevin::memory_usage() { double bytes = 0.0; - if (gjfflag) bytes += atom->nmax*3 * sizeof(double); + if (gjfflag) bytes += atom->nmax*3*2 * sizeof(double); + if (gjfflag) if (hsflag) bytes += atom->nmax*3 * sizeof(double); if (tallyflag) bytes += atom->nmax*3 * sizeof(double); if (tforce) bytes += atom->nmax * sizeof(double); return bytes; @@ -882,6 +1031,8 @@ double FixLangevin::memory_usage() void FixLangevin::grow_arrays(int nmax) { memory->grow(franprev,nmax,3,"fix_langevin:franprev"); + memory->grow(wildcard,nmax,3,"fix_langevin:wildcard"); + if (hsflag) memory->grow(lv,nmax,3,"fix_langevin:lv"); } /* ---------------------------------------------------------------------- @@ -890,8 +1041,17 @@ void FixLangevin::grow_arrays(int nmax) void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) { - for (int m = 0; m < nvalues; m++) - franprev[j][m] = franprev[i][m]; + franprev[j][0] = franprev[i][0]; + franprev[j][1] = franprev[i][1]; + franprev[j][2] = franprev[i][2]; + wildcard[j][0] = wildcard[i][0]; + wildcard[j][1] = wildcard[i][1]; + wildcard[j][2] = wildcard[i][2]; + if (hsflag) { + lv[j][0] = lv[i][0]; + lv[j][1] = lv[i][1]; + lv[j][2] = lv[i][2]; + } } /* ---------------------------------------------------------------------- @@ -900,8 +1060,19 @@ void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) int FixLangevin::pack_exchange(int i, double *buf) { - for (int m = 0; m < nvalues; m++) buf[m] = franprev[i][m]; - return nvalues; + int n = 0; + buf[n++] = franprev[i][0]; + buf[n++] = franprev[i][1]; + buf[n++] = franprev[i][2]; + buf[n++] = wildcard[i][0]; + buf[n++] = wildcard[i][1]; + buf[n++] = wildcard[i][2]; + if (hsflag){ + buf[n++] = lv[i][0]; + buf[n++] = lv[i][1]; + buf[n++] = lv[i][2]; + } + return n; } /* ---------------------------------------------------------------------- @@ -910,6 +1081,17 @@ int FixLangevin::pack_exchange(int i, double *buf) int FixLangevin::unpack_exchange(int nlocal, double *buf) { - for (int m = 0; m < nvalues; m++) franprev[nlocal][m] = buf[m]; - return nvalues; + int n = 0; + franprev[nlocal][0] = buf[n++]; + franprev[nlocal][1] = buf[n++]; + franprev[nlocal][2] = buf[n++]; + wildcard[nlocal][0] = buf[n++]; + wildcard[nlocal][1] = buf[n++]; + wildcard[nlocal][2] = buf[n++]; + if (hsflag){ + lv[nlocal][0] = buf[n++]; + lv[nlocal][1] = buf[n++]; + lv[nlocal][2] = buf[n++]; + } + return n; } diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 4b5570ac2e..461d4e5140 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -31,6 +31,8 @@ class FixLangevin : public Fix { int setmask(); void init(); void setup(int); + //virtual void initial_integrate(int); + virtual void post_integrate(); virtual void post_force(int); void post_force_respa(int, int, int); virtual void end_of_step(); @@ -46,7 +48,7 @@ class FixLangevin : public Fix { int unpack_exchange(int, double *); protected: - int gjfflag,oflag,tallyflag,zeroflag,tbiasflag; + int gjfflag,oflag,tallyflag,zeroflag,tbiasflag,hsflag; int flangevin_allocated; double ascale; double t_start,t_stop,t_period,t_target; @@ -63,6 +65,9 @@ class FixLangevin : public Fix { double **flangevin; double *tforce; double **franprev; + double **lv; //lucas velocity or half-step velocity + double **wildcard; + int nvalues; char *id_temp; From e38072f365d40a915328b9656b0a27d5ac1ef4ed Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 13:51:36 -0700 Subject: [PATCH 070/557] added lammps python example --- examples/python/gjf_python/argon.lmp | 886 +++++++++++++++++++++ examples/python/gjf_python/ff-argon.lmp | 20 + examples/python/gjf_python/gjf.py | 180 +++++ examples/python/gjf_python/lammps_tools.py | 78 ++ 4 files changed, 1164 insertions(+) create mode 100644 examples/python/gjf_python/argon.lmp create mode 100644 examples/python/gjf_python/ff-argon.lmp create mode 100644 examples/python/gjf_python/gjf.py create mode 100644 examples/python/gjf_python/lammps_tools.py diff --git a/examples/python/gjf_python/argon.lmp b/examples/python/gjf_python/argon.lmp new file mode 100644 index 0000000000..00214b4c54 --- /dev/null +++ b/examples/python/gjf_python/argon.lmp @@ -0,0 +1,886 @@ +LAMMPS description + + 864 atoms + 0 bonds + 0 angles + 0 dihedrals + 0 impropers + + 1 atom types + 0 bond types + 0 angle types + 0 dihedral types + 0 improper types + + + 0.0000000 32.146000 xlo xhi + 0.0000000 32.146000 ylo yhi + 0.0000000 32.146000 zlo zhi + + Atoms + + 1 1 1 0.0000000 0.0000000 2.6790000 2.6790000 + 2 2 1 0.0000000 0.0000000 2.6790000 8.0360000 + 3 3 1 0.0000000 0.0000000 2.6790000 13.3940000 + 4 4 1 0.0000000 0.0000000 2.6790000 18.7520000 + 5 5 1 0.0000000 0.0000000 2.6790000 24.1090000 + 6 6 1 0.0000000 0.0000000 2.6790000 29.4670000 + 7 7 1 0.0000000 0.0000000 8.0360000 2.6790000 + 8 8 1 0.0000000 0.0000000 8.0360000 8.0360000 + 9 9 1 0.0000000 0.0000000 8.0360000 13.3940000 + 10 10 1 0.0000000 0.0000000 8.0360000 18.7520000 + 11 11 1 0.0000000 0.0000000 8.0360000 24.1090000 + 12 12 1 0.0000000 0.0000000 8.0360000 29.4670000 + 13 13 1 0.0000000 0.0000000 13.3940000 2.6790000 + 14 14 1 0.0000000 0.0000000 13.3940000 8.0360000 + 15 15 1 0.0000000 0.0000000 13.3940000 13.3940000 + 16 16 1 0.0000000 0.0000000 13.3940000 18.7520000 + 17 17 1 0.0000000 0.0000000 13.3940000 24.1090000 + 18 18 1 0.0000000 0.0000000 13.3940000 29.4670000 + 19 19 1 0.0000000 0.0000000 18.7520000 2.6790000 + 20 20 1 0.0000000 0.0000000 18.7520000 8.0360000 + 21 21 1 0.0000000 0.0000000 18.7520000 13.3940000 + 22 22 1 0.0000000 0.0000000 18.7520000 18.7520000 + 23 23 1 0.0000000 0.0000000 18.7520000 24.1090000 + 24 24 1 0.0000000 0.0000000 18.7520000 29.4670000 + 25 25 1 0.0000000 0.0000000 24.1090000 2.6790000 + 26 26 1 0.0000000 0.0000000 24.1090000 8.0360000 + 27 27 1 0.0000000 0.0000000 24.1090000 13.3940000 + 28 28 1 0.0000000 0.0000000 24.1090000 18.7520000 + 29 29 1 0.0000000 0.0000000 24.1090000 24.1090000 + 30 30 1 0.0000000 0.0000000 24.1090000 29.4670000 + 31 31 1 0.0000000 0.0000000 29.4670000 2.6790000 + 32 32 1 0.0000000 0.0000000 29.4670000 8.0360000 + 33 33 1 0.0000000 0.0000000 29.4670000 13.3940000 + 34 34 1 0.0000000 0.0000000 29.4670000 18.7520000 + 35 35 1 0.0000000 0.0000000 29.4670000 24.1090000 + 36 36 1 0.0000000 0.0000000 29.4670000 29.4670000 + 37 37 1 0.0000000 5.3580000 2.6790000 2.6790000 + 38 38 1 0.0000000 5.3580000 2.6790000 8.0360000 + 39 39 1 0.0000000 5.3580000 2.6790000 13.3940000 + 40 40 1 0.0000000 5.3580000 2.6790000 18.7520000 + 41 41 1 0.0000000 5.3580000 2.6790000 24.1090000 + 42 42 1 0.0000000 5.3580000 2.6790000 29.4670000 + 43 43 1 0.0000000 5.3580000 8.0360000 2.6790000 + 44 44 1 0.0000000 5.3580000 8.0360000 8.0360000 + 45 45 1 0.0000000 5.3580000 8.0360000 13.3940000 + 46 46 1 0.0000000 5.3580000 8.0360000 18.7520000 + 47 47 1 0.0000000 5.3580000 8.0360000 24.1090000 + 48 48 1 0.0000000 5.3580000 8.0360000 29.4670000 + 49 49 1 0.0000000 5.3580000 13.3940000 2.6790000 + 50 50 1 0.0000000 5.3580000 13.3940000 8.0360000 + 51 51 1 0.0000000 5.3580000 13.3940000 13.3940000 + 52 52 1 0.0000000 5.3580000 13.3940000 18.7520000 + 53 53 1 0.0000000 5.3580000 13.3940000 24.1090000 + 54 54 1 0.0000000 5.3580000 13.3940000 29.4670000 + 55 55 1 0.0000000 5.3580000 18.7520000 2.6790000 + 56 56 1 0.0000000 5.3580000 18.7520000 8.0360000 + 57 57 1 0.0000000 5.3580000 18.7520000 13.3940000 + 58 58 1 0.0000000 5.3580000 18.7520000 18.7520000 + 59 59 1 0.0000000 5.3580000 18.7520000 24.1090000 + 60 60 1 0.0000000 5.3580000 18.7520000 29.4670000 + 61 61 1 0.0000000 5.3580000 24.1090000 2.6790000 + 62 62 1 0.0000000 5.3580000 24.1090000 8.0360000 + 63 63 1 0.0000000 5.3580000 24.1090000 13.3940000 + 64 64 1 0.0000000 5.3580000 24.1090000 18.7520000 + 65 65 1 0.0000000 5.3580000 24.1090000 24.1090000 + 66 66 1 0.0000000 5.3580000 24.1090000 29.4670000 + 67 67 1 0.0000000 5.3580000 29.4670000 2.6790000 + 68 68 1 0.0000000 5.3580000 29.4670000 8.0360000 + 69 69 1 0.0000000 5.3580000 29.4670000 13.3940000 + 70 70 1 0.0000000 5.3580000 29.4670000 18.7520000 + 71 71 1 0.0000000 5.3580000 29.4670000 24.1090000 + 72 72 1 0.0000000 5.3580000 29.4670000 29.4670000 + 73 73 1 0.0000000 10.7150000 2.6790000 2.6790000 + 74 74 1 0.0000000 10.7150000 2.6790000 8.0360000 + 75 75 1 0.0000000 10.7150000 2.6790000 13.3940000 + 76 76 1 0.0000000 10.7150000 2.6790000 18.7520000 + 77 77 1 0.0000000 10.7150000 2.6790000 24.1090000 + 78 78 1 0.0000000 10.7150000 2.6790000 29.4670000 + 79 79 1 0.0000000 10.7150000 8.0360000 2.6790000 + 80 80 1 0.0000000 10.7150000 8.0360000 8.0360000 + 81 81 1 0.0000000 10.7150000 8.0360000 13.3940000 + 82 82 1 0.0000000 10.7150000 8.0360000 18.7520000 + 83 83 1 0.0000000 10.7150000 8.0360000 24.1090000 + 84 84 1 0.0000000 10.7150000 8.0360000 29.4670000 + 85 85 1 0.0000000 10.7150000 13.3940000 2.6790000 + 86 86 1 0.0000000 10.7150000 13.3940000 8.0360000 + 87 87 1 0.0000000 10.7150000 13.3940000 13.3940000 + 88 88 1 0.0000000 10.7150000 13.3940000 18.7520000 + 89 89 1 0.0000000 10.7150000 13.3940000 24.1090000 + 90 90 1 0.0000000 10.7150000 13.3940000 29.4670000 + 91 91 1 0.0000000 10.7150000 18.7520000 2.6790000 + 92 92 1 0.0000000 10.7150000 18.7520000 8.0360000 + 93 93 1 0.0000000 10.7150000 18.7520000 13.3940000 + 94 94 1 0.0000000 10.7150000 18.7520000 18.7520000 + 95 95 1 0.0000000 10.7150000 18.7520000 24.1090000 + 96 96 1 0.0000000 10.7150000 18.7520000 29.4670000 + 97 97 1 0.0000000 10.7150000 24.1090000 2.6790000 + 98 98 1 0.0000000 10.7150000 24.1090000 8.0360000 + 99 99 1 0.0000000 10.7150000 24.1090000 13.3940000 + 100 100 1 0.0000000 10.7150000 24.1090000 18.7520000 + 101 101 1 0.0000000 10.7150000 24.1090000 24.1090000 + 102 102 1 0.0000000 10.7150000 24.1090000 29.4670000 + 103 103 1 0.0000000 10.7150000 29.4670000 2.6790000 + 104 104 1 0.0000000 10.7150000 29.4670000 8.0360000 + 105 105 1 0.0000000 10.7150000 29.4670000 13.3940000 + 106 106 1 0.0000000 10.7150000 29.4670000 18.7520000 + 107 107 1 0.0000000 10.7150000 29.4670000 24.1090000 + 108 108 1 0.0000000 10.7150000 29.4670000 29.4670000 + 109 109 1 0.0000000 16.0730000 2.6790000 2.6790000 + 110 110 1 0.0000000 16.0730000 2.6790000 8.0360000 + 111 111 1 0.0000000 16.0730000 2.6790000 13.3940000 + 112 112 1 0.0000000 16.0730000 2.6790000 18.7520000 + 113 113 1 0.0000000 16.0730000 2.6790000 24.1090000 + 114 114 1 0.0000000 16.0730000 2.6790000 29.4670000 + 115 115 1 0.0000000 16.0730000 8.0360000 2.6790000 + 116 116 1 0.0000000 16.0730000 8.0360000 8.0360000 + 117 117 1 0.0000000 16.0730000 8.0360000 13.3940000 + 118 118 1 0.0000000 16.0730000 8.0360000 18.7520000 + 119 119 1 0.0000000 16.0730000 8.0360000 24.1090000 + 120 120 1 0.0000000 16.0730000 8.0360000 29.4670000 + 121 121 1 0.0000000 16.0730000 13.3940000 2.6790000 + 122 122 1 0.0000000 16.0730000 13.3940000 8.0360000 + 123 123 1 0.0000000 16.0730000 13.3940000 13.3940000 + 124 124 1 0.0000000 16.0730000 13.3940000 18.7520000 + 125 125 1 0.0000000 16.0730000 13.3940000 24.1090000 + 126 126 1 0.0000000 16.0730000 13.3940000 29.4670000 + 127 127 1 0.0000000 16.0730000 18.7520000 2.6790000 + 128 128 1 0.0000000 16.0730000 18.7520000 8.0360000 + 129 129 1 0.0000000 16.0730000 18.7520000 13.3940000 + 130 130 1 0.0000000 16.0730000 18.7520000 18.7520000 + 131 131 1 0.0000000 16.0730000 18.7520000 24.1090000 + 132 132 1 0.0000000 16.0730000 18.7520000 29.4670000 + 133 133 1 0.0000000 16.0730000 24.1090000 2.6790000 + 134 134 1 0.0000000 16.0730000 24.1090000 8.0360000 + 135 135 1 0.0000000 16.0730000 24.1090000 13.3940000 + 136 136 1 0.0000000 16.0730000 24.1090000 18.7520000 + 137 137 1 0.0000000 16.0730000 24.1090000 24.1090000 + 138 138 1 0.0000000 16.0730000 24.1090000 29.4670000 + 139 139 1 0.0000000 16.0730000 29.4670000 2.6790000 + 140 140 1 0.0000000 16.0730000 29.4670000 8.0360000 + 141 141 1 0.0000000 16.0730000 29.4670000 13.3940000 + 142 142 1 0.0000000 16.0730000 29.4670000 18.7520000 + 143 143 1 0.0000000 16.0730000 29.4670000 24.1090000 + 144 144 1 0.0000000 16.0730000 29.4670000 29.4670000 + 145 145 1 0.0000000 21.4310000 2.6790000 2.6790000 + 146 146 1 0.0000000 21.4310000 2.6790000 8.0360000 + 147 147 1 0.0000000 21.4310000 2.6790000 13.3940000 + 148 148 1 0.0000000 21.4310000 2.6790000 18.7520000 + 149 149 1 0.0000000 21.4310000 2.6790000 24.1090000 + 150 150 1 0.0000000 21.4310000 2.6790000 29.4670000 + 151 151 1 0.0000000 21.4310000 8.0360000 2.6790000 + 152 152 1 0.0000000 21.4310000 8.0360000 8.0360000 + 153 153 1 0.0000000 21.4310000 8.0360000 13.3940000 + 154 154 1 0.0000000 21.4310000 8.0360000 18.7520000 + 155 155 1 0.0000000 21.4310000 8.0360000 24.1090000 + 156 156 1 0.0000000 21.4310000 8.0360000 29.4670000 + 157 157 1 0.0000000 21.4310000 13.3940000 2.6790000 + 158 158 1 0.0000000 21.4310000 13.3940000 8.0360000 + 159 159 1 0.0000000 21.4310000 13.3940000 13.3940000 + 160 160 1 0.0000000 21.4310000 13.3940000 18.7520000 + 161 161 1 0.0000000 21.4310000 13.3940000 24.1090000 + 162 162 1 0.0000000 21.4310000 13.3940000 29.4670000 + 163 163 1 0.0000000 21.4310000 18.7520000 2.6790000 + 164 164 1 0.0000000 21.4310000 18.7520000 8.0360000 + 165 165 1 0.0000000 21.4310000 18.7520000 13.3940000 + 166 166 1 0.0000000 21.4310000 18.7520000 18.7520000 + 167 167 1 0.0000000 21.4310000 18.7520000 24.1090000 + 168 168 1 0.0000000 21.4310000 18.7520000 29.4670000 + 169 169 1 0.0000000 21.4310000 24.1090000 2.6790000 + 170 170 1 0.0000000 21.4310000 24.1090000 8.0360000 + 171 171 1 0.0000000 21.4310000 24.1090000 13.3940000 + 172 172 1 0.0000000 21.4310000 24.1090000 18.7520000 + 173 173 1 0.0000000 21.4310000 24.1090000 24.1090000 + 174 174 1 0.0000000 21.4310000 24.1090000 29.4670000 + 175 175 1 0.0000000 21.4310000 29.4670000 2.6790000 + 176 176 1 0.0000000 21.4310000 29.4670000 8.0360000 + 177 177 1 0.0000000 21.4310000 29.4670000 13.3940000 + 178 178 1 0.0000000 21.4310000 29.4670000 18.7520000 + 179 179 1 0.0000000 21.4310000 29.4670000 24.1090000 + 180 180 1 0.0000000 21.4310000 29.4670000 29.4670000 + 181 181 1 0.0000000 26.7880000 2.6790000 2.6790000 + 182 182 1 0.0000000 26.7880000 2.6790000 8.0360000 + 183 183 1 0.0000000 26.7880000 2.6790000 13.3940000 + 184 184 1 0.0000000 26.7880000 2.6790000 18.7520000 + 185 185 1 0.0000000 26.7880000 2.6790000 24.1090000 + 186 186 1 0.0000000 26.7880000 2.6790000 29.4670000 + 187 187 1 0.0000000 26.7880000 8.0360000 2.6790000 + 188 188 1 0.0000000 26.7880000 8.0360000 8.0360000 + 189 189 1 0.0000000 26.7880000 8.0360000 13.3940000 + 190 190 1 0.0000000 26.7880000 8.0360000 18.7520000 + 191 191 1 0.0000000 26.7880000 8.0360000 24.1090000 + 192 192 1 0.0000000 26.7880000 8.0360000 29.4670000 + 193 193 1 0.0000000 26.7880000 13.3940000 2.6790000 + 194 194 1 0.0000000 26.7880000 13.3940000 8.0360000 + 195 195 1 0.0000000 26.7880000 13.3940000 13.3940000 + 196 196 1 0.0000000 26.7880000 13.3940000 18.7520000 + 197 197 1 0.0000000 26.7880000 13.3940000 24.1090000 + 198 198 1 0.0000000 26.7880000 13.3940000 29.4670000 + 199 199 1 0.0000000 26.7880000 18.7520000 2.6790000 + 200 200 1 0.0000000 26.7880000 18.7520000 8.0360000 + 201 201 1 0.0000000 26.7880000 18.7520000 13.3940000 + 202 202 1 0.0000000 26.7880000 18.7520000 18.7520000 + 203 203 1 0.0000000 26.7880000 18.7520000 24.1090000 + 204 204 1 0.0000000 26.7880000 18.7520000 29.4670000 + 205 205 1 0.0000000 26.7880000 24.1090000 2.6790000 + 206 206 1 0.0000000 26.7880000 24.1090000 8.0360000 + 207 207 1 0.0000000 26.7880000 24.1090000 13.3940000 + 208 208 1 0.0000000 26.7880000 24.1090000 18.7520000 + 209 209 1 0.0000000 26.7880000 24.1090000 24.1090000 + 210 210 1 0.0000000 26.7880000 24.1090000 29.4670000 + 211 211 1 0.0000000 26.7880000 29.4670000 2.6790000 + 212 212 1 0.0000000 26.7880000 29.4670000 8.0360000 + 213 213 1 0.0000000 26.7880000 29.4670000 13.3940000 + 214 214 1 0.0000000 26.7880000 29.4670000 18.7520000 + 215 215 1 0.0000000 26.7880000 29.4670000 24.1090000 + 216 216 1 0.0000000 26.7880000 29.4670000 29.4670000 + 217 217 1 0.0000000 2.6790000 5.3580000 2.6790000 + 218 218 1 0.0000000 2.6790000 5.3580000 8.0360000 + 219 219 1 0.0000000 2.6790000 5.3580000 13.3940000 + 220 220 1 0.0000000 2.6790000 5.3580000 18.7520000 + 221 221 1 0.0000000 2.6790000 5.3580000 24.1090000 + 222 222 1 0.0000000 2.6790000 5.3580000 29.4670000 + 223 223 1 0.0000000 2.6790000 10.7150000 2.6790000 + 224 224 1 0.0000000 2.6790000 10.7150000 8.0360000 + 225 225 1 0.0000000 2.6790000 10.7150000 13.3940000 + 226 226 1 0.0000000 2.6790000 10.7150000 18.7520000 + 227 227 1 0.0000000 2.6790000 10.7150000 24.1090000 + 228 228 1 0.0000000 2.6790000 10.7150000 29.4670000 + 229 229 1 0.0000000 2.6790000 16.0730000 2.6790000 + 230 230 1 0.0000000 2.6790000 16.0730000 8.0360000 + 231 231 1 0.0000000 2.6790000 16.0730000 13.3940000 + 232 232 1 0.0000000 2.6790000 16.0730000 18.7520000 + 233 233 1 0.0000000 2.6790000 16.0730000 24.1090000 + 234 234 1 0.0000000 2.6790000 16.0730000 29.4670000 + 235 235 1 0.0000000 2.6790000 21.4310000 2.6790000 + 236 236 1 0.0000000 2.6790000 21.4310000 8.0360000 + 237 237 1 0.0000000 2.6790000 21.4310000 13.3940000 + 238 238 1 0.0000000 2.6790000 21.4310000 18.7520000 + 239 239 1 0.0000000 2.6790000 21.4310000 24.1090000 + 240 240 1 0.0000000 2.6790000 21.4310000 29.4670000 + 241 241 1 0.0000000 2.6790000 26.7880000 2.6790000 + 242 242 1 0.0000000 2.6790000 26.7880000 8.0360000 + 243 243 1 0.0000000 2.6790000 26.7880000 13.3940000 + 244 244 1 0.0000000 2.6790000 26.7880000 18.7520000 + 245 245 1 0.0000000 2.6790000 26.7880000 24.1090000 + 246 246 1 0.0000000 2.6790000 26.7880000 29.4670000 + 247 247 1 0.0000000 2.6790000 32.1460000 2.6790000 + 248 248 1 0.0000000 2.6790000 32.1460000 8.0360000 + 249 249 1 0.0000000 2.6790000 32.1460000 13.3940000 + 250 250 1 0.0000000 2.6790000 32.1460000 18.7520000 + 251 251 1 0.0000000 2.6790000 32.1460000 24.1090000 + 252 252 1 0.0000000 2.6790000 32.1460000 29.4670000 + 253 253 1 0.0000000 8.0360000 5.3580000 2.6790000 + 254 254 1 0.0000000 8.0360000 5.3580000 8.0360000 + 255 255 1 0.0000000 8.0360000 5.3580000 13.3940000 + 256 256 1 0.0000000 8.0360000 5.3580000 18.7520000 + 257 257 1 0.0000000 8.0360000 5.3580000 24.1090000 + 258 258 1 0.0000000 8.0360000 5.3580000 29.4670000 + 259 259 1 0.0000000 8.0360000 10.7150000 2.6790000 + 260 260 1 0.0000000 8.0360000 10.7150000 8.0360000 + 261 261 1 0.0000000 8.0360000 10.7150000 13.3940000 + 262 262 1 0.0000000 8.0360000 10.7150000 18.7520000 + 263 263 1 0.0000000 8.0360000 10.7150000 24.1090000 + 264 264 1 0.0000000 8.0360000 10.7150000 29.4670000 + 265 265 1 0.0000000 8.0360000 16.0730000 2.6790000 + 266 266 1 0.0000000 8.0360000 16.0730000 8.0360000 + 267 267 1 0.0000000 8.0360000 16.0730000 13.3940000 + 268 268 1 0.0000000 8.0360000 16.0730000 18.7520000 + 269 269 1 0.0000000 8.0360000 16.0730000 24.1090000 + 270 270 1 0.0000000 8.0360000 16.0730000 29.4670000 + 271 271 1 0.0000000 8.0360000 21.4310000 2.6790000 + 272 272 1 0.0000000 8.0360000 21.4310000 8.0360000 + 273 273 1 0.0000000 8.0360000 21.4310000 13.3940000 + 274 274 1 0.0000000 8.0360000 21.4310000 18.7520000 + 275 275 1 0.0000000 8.0360000 21.4310000 24.1090000 + 276 276 1 0.0000000 8.0360000 21.4310000 29.4670000 + 277 277 1 0.0000000 8.0360000 26.7880000 2.6790000 + 278 278 1 0.0000000 8.0360000 26.7880000 8.0360000 + 279 279 1 0.0000000 8.0360000 26.7880000 13.3940000 + 280 280 1 0.0000000 8.0360000 26.7880000 18.7520000 + 281 281 1 0.0000000 8.0360000 26.7880000 24.1090000 + 282 282 1 0.0000000 8.0360000 26.7880000 29.4670000 + 283 283 1 0.0000000 8.0360000 32.1460000 2.6790000 + 284 284 1 0.0000000 8.0360000 32.1460000 8.0360000 + 285 285 1 0.0000000 8.0360000 32.1460000 13.3940000 + 286 286 1 0.0000000 8.0360000 32.1460000 18.7520000 + 287 287 1 0.0000000 8.0360000 32.1460000 24.1090000 + 288 288 1 0.0000000 8.0360000 32.1460000 29.4670000 + 289 289 1 0.0000000 13.3940000 5.3580000 2.6790000 + 290 290 1 0.0000000 13.3940000 5.3580000 8.0360000 + 291 291 1 0.0000000 13.3940000 5.3580000 13.3940000 + 292 292 1 0.0000000 13.3940000 5.3580000 18.7520000 + 293 293 1 0.0000000 13.3940000 5.3580000 24.1090000 + 294 294 1 0.0000000 13.3940000 5.3580000 29.4670000 + 295 295 1 0.0000000 13.3940000 10.7150000 2.6790000 + 296 296 1 0.0000000 13.3940000 10.7150000 8.0360000 + 297 297 1 0.0000000 13.3940000 10.7150000 13.3940000 + 298 298 1 0.0000000 13.3940000 10.7150000 18.7520000 + 299 299 1 0.0000000 13.3940000 10.7150000 24.1090000 + 300 300 1 0.0000000 13.3940000 10.7150000 29.4670000 + 301 301 1 0.0000000 13.3940000 16.0730000 2.6790000 + 302 302 1 0.0000000 13.3940000 16.0730000 8.0360000 + 303 303 1 0.0000000 13.3940000 16.0730000 13.3940000 + 304 304 1 0.0000000 13.3940000 16.0730000 18.7520000 + 305 305 1 0.0000000 13.3940000 16.0730000 24.1090000 + 306 306 1 0.0000000 13.3940000 16.0730000 29.4670000 + 307 307 1 0.0000000 13.3940000 21.4310000 2.6790000 + 308 308 1 0.0000000 13.3940000 21.4310000 8.0360000 + 309 309 1 0.0000000 13.3940000 21.4310000 13.3940000 + 310 310 1 0.0000000 13.3940000 21.4310000 18.7520000 + 311 311 1 0.0000000 13.3940000 21.4310000 24.1090000 + 312 312 1 0.0000000 13.3940000 21.4310000 29.4670000 + 313 313 1 0.0000000 13.3940000 26.7880000 2.6790000 + 314 314 1 0.0000000 13.3940000 26.7880000 8.0360000 + 315 315 1 0.0000000 13.3940000 26.7880000 13.3940000 + 316 316 1 0.0000000 13.3940000 26.7880000 18.7520000 + 317 317 1 0.0000000 13.3940000 26.7880000 24.1090000 + 318 318 1 0.0000000 13.3940000 26.7880000 29.4670000 + 319 319 1 0.0000000 13.3940000 32.1460000 2.6790000 + 320 320 1 0.0000000 13.3940000 32.1460000 8.0360000 + 321 321 1 0.0000000 13.3940000 32.1460000 13.3940000 + 322 322 1 0.0000000 13.3940000 32.1460000 18.7520000 + 323 323 1 0.0000000 13.3940000 32.1460000 24.1090000 + 324 324 1 0.0000000 13.3940000 32.1460000 29.4670000 + 325 325 1 0.0000000 18.7520000 5.3580000 2.6790000 + 326 326 1 0.0000000 18.7520000 5.3580000 8.0360000 + 327 327 1 0.0000000 18.7520000 5.3580000 13.3940000 + 328 328 1 0.0000000 18.7520000 5.3580000 18.7520000 + 329 329 1 0.0000000 18.7520000 5.3580000 24.1090000 + 330 330 1 0.0000000 18.7520000 5.3580000 29.4670000 + 331 331 1 0.0000000 18.7520000 10.7150000 2.6790000 + 332 332 1 0.0000000 18.7520000 10.7150000 8.0360000 + 333 333 1 0.0000000 18.7520000 10.7150000 13.3940000 + 334 334 1 0.0000000 18.7520000 10.7150000 18.7520000 + 335 335 1 0.0000000 18.7520000 10.7150000 24.1090000 + 336 336 1 0.0000000 18.7520000 10.7150000 29.4670000 + 337 337 1 0.0000000 18.7520000 16.0730000 2.6790000 + 338 338 1 0.0000000 18.7520000 16.0730000 8.0360000 + 339 339 1 0.0000000 18.7520000 16.0730000 13.3940000 + 340 340 1 0.0000000 18.7520000 16.0730000 18.7520000 + 341 341 1 0.0000000 18.7520000 16.0730000 24.1090000 + 342 342 1 0.0000000 18.7520000 16.0730000 29.4670000 + 343 343 1 0.0000000 18.7520000 21.4310000 2.6790000 + 344 344 1 0.0000000 18.7520000 21.4310000 8.0360000 + 345 345 1 0.0000000 18.7520000 21.4310000 13.3940000 + 346 346 1 0.0000000 18.7520000 21.4310000 18.7520000 + 347 347 1 0.0000000 18.7520000 21.4310000 24.1090000 + 348 348 1 0.0000000 18.7520000 21.4310000 29.4670000 + 349 349 1 0.0000000 18.7520000 26.7880000 2.6790000 + 350 350 1 0.0000000 18.7520000 26.7880000 8.0360000 + 351 351 1 0.0000000 18.7520000 26.7880000 13.3940000 + 352 352 1 0.0000000 18.7520000 26.7880000 18.7520000 + 353 353 1 0.0000000 18.7520000 26.7880000 24.1090000 + 354 354 1 0.0000000 18.7520000 26.7880000 29.4670000 + 355 355 1 0.0000000 18.7520000 32.1460000 2.6790000 + 356 356 1 0.0000000 18.7520000 32.1460000 8.0360000 + 357 357 1 0.0000000 18.7520000 32.1460000 13.3940000 + 358 358 1 0.0000000 18.7520000 32.1460000 18.7520000 + 359 359 1 0.0000000 18.7520000 32.1460000 24.1090000 + 360 360 1 0.0000000 18.7520000 32.1460000 29.4670000 + 361 361 1 0.0000000 24.1090000 5.3580000 2.6790000 + 362 362 1 0.0000000 24.1090000 5.3580000 8.0360000 + 363 363 1 0.0000000 24.1090000 5.3580000 13.3940000 + 364 364 1 0.0000000 24.1090000 5.3580000 18.7520000 + 365 365 1 0.0000000 24.1090000 5.3580000 24.1090000 + 366 366 1 0.0000000 24.1090000 5.3580000 29.4670000 + 367 367 1 0.0000000 24.1090000 10.7150000 2.6790000 + 368 368 1 0.0000000 24.1090000 10.7150000 8.0360000 + 369 369 1 0.0000000 24.1090000 10.7150000 13.3940000 + 370 370 1 0.0000000 24.1090000 10.7150000 18.7520000 + 371 371 1 0.0000000 24.1090000 10.7150000 24.1090000 + 372 372 1 0.0000000 24.1090000 10.7150000 29.4670000 + 373 373 1 0.0000000 24.1090000 16.0730000 2.6790000 + 374 374 1 0.0000000 24.1090000 16.0730000 8.0360000 + 375 375 1 0.0000000 24.1090000 16.0730000 13.3940000 + 376 376 1 0.0000000 24.1090000 16.0730000 18.7520000 + 377 377 1 0.0000000 24.1090000 16.0730000 24.1090000 + 378 378 1 0.0000000 24.1090000 16.0730000 29.4670000 + 379 379 1 0.0000000 24.1090000 21.4310000 2.6790000 + 380 380 1 0.0000000 24.1090000 21.4310000 8.0360000 + 381 381 1 0.0000000 24.1090000 21.4310000 13.3940000 + 382 382 1 0.0000000 24.1090000 21.4310000 18.7520000 + 383 383 1 0.0000000 24.1090000 21.4310000 24.1090000 + 384 384 1 0.0000000 24.1090000 21.4310000 29.4670000 + 385 385 1 0.0000000 24.1090000 26.7880000 2.6790000 + 386 386 1 0.0000000 24.1090000 26.7880000 8.0360000 + 387 387 1 0.0000000 24.1090000 26.7880000 13.3940000 + 388 388 1 0.0000000 24.1090000 26.7880000 18.7520000 + 389 389 1 0.0000000 24.1090000 26.7880000 24.1090000 + 390 390 1 0.0000000 24.1090000 26.7880000 29.4670000 + 391 391 1 0.0000000 24.1090000 32.1460000 2.6790000 + 392 392 1 0.0000000 24.1090000 32.1460000 8.0360000 + 393 393 1 0.0000000 24.1090000 32.1460000 13.3940000 + 394 394 1 0.0000000 24.1090000 32.1460000 18.7520000 + 395 395 1 0.0000000 24.1090000 32.1460000 24.1090000 + 396 396 1 0.0000000 24.1090000 32.1460000 29.4670000 + 397 397 1 0.0000000 29.4670000 5.3580000 2.6790000 + 398 398 1 0.0000000 29.4670000 5.3580000 8.0360000 + 399 399 1 0.0000000 29.4670000 5.3580000 13.3940000 + 400 400 1 0.0000000 29.4670000 5.3580000 18.7520000 + 401 401 1 0.0000000 29.4670000 5.3580000 24.1090000 + 402 402 1 0.0000000 29.4670000 5.3580000 29.4670000 + 403 403 1 0.0000000 29.4670000 10.7150000 2.6790000 + 404 404 1 0.0000000 29.4670000 10.7150000 8.0360000 + 405 405 1 0.0000000 29.4670000 10.7150000 13.3940000 + 406 406 1 0.0000000 29.4670000 10.7150000 18.7520000 + 407 407 1 0.0000000 29.4670000 10.7150000 24.1090000 + 408 408 1 0.0000000 29.4670000 10.7150000 29.4670000 + 409 409 1 0.0000000 29.4670000 16.0730000 2.6790000 + 410 410 1 0.0000000 29.4670000 16.0730000 8.0360000 + 411 411 1 0.0000000 29.4670000 16.0730000 13.3940000 + 412 412 1 0.0000000 29.4670000 16.0730000 18.7520000 + 413 413 1 0.0000000 29.4670000 16.0730000 24.1090000 + 414 414 1 0.0000000 29.4670000 16.0730000 29.4670000 + 415 415 1 0.0000000 29.4670000 21.4310000 2.6790000 + 416 416 1 0.0000000 29.4670000 21.4310000 8.0360000 + 417 417 1 0.0000000 29.4670000 21.4310000 13.3940000 + 418 418 1 0.0000000 29.4670000 21.4310000 18.7520000 + 419 419 1 0.0000000 29.4670000 21.4310000 24.1090000 + 420 420 1 0.0000000 29.4670000 21.4310000 29.4670000 + 421 421 1 0.0000000 29.4670000 26.7880000 2.6790000 + 422 422 1 0.0000000 29.4670000 26.7880000 8.0360000 + 423 423 1 0.0000000 29.4670000 26.7880000 13.3940000 + 424 424 1 0.0000000 29.4670000 26.7880000 18.7520000 + 425 425 1 0.0000000 29.4670000 26.7880000 24.1090000 + 426 426 1 0.0000000 29.4670000 26.7880000 29.4670000 + 427 427 1 0.0000000 29.4670000 32.1460000 2.6790000 + 428 428 1 0.0000000 29.4670000 32.1460000 8.0360000 + 429 429 1 0.0000000 29.4670000 32.1460000 13.3940000 + 430 430 1 0.0000000 29.4670000 32.1460000 18.7520000 + 431 431 1 0.0000000 29.4670000 32.1460000 24.1090000 + 432 432 1 0.0000000 29.4670000 32.1460000 29.4670000 + 433 433 1 0.0000000 2.6790000 2.6790000 5.3580000 + 434 434 1 0.0000000 2.6790000 2.6790000 10.7150000 + 435 435 1 0.0000000 2.6790000 2.6790000 16.0730000 + 436 436 1 0.0000000 2.6790000 2.6790000 21.4310000 + 437 437 1 0.0000000 2.6790000 2.6790000 26.7880000 + 438 438 1 0.0000000 2.6790000 2.6790000 32.1460000 + 439 439 1 0.0000000 2.6790000 8.0360000 5.3580000 + 440 440 1 0.0000000 2.6790000 8.0360000 10.7150000 + 441 441 1 0.0000000 2.6790000 8.0360000 16.0730000 + 442 442 1 0.0000000 2.6790000 8.0360000 21.4310000 + 443 443 1 0.0000000 2.6790000 8.0360000 26.7880000 + 444 444 1 0.0000000 2.6790000 8.0360000 32.1460000 + 445 445 1 0.0000000 2.6790000 13.3940000 5.3580000 + 446 446 1 0.0000000 2.6790000 13.3940000 10.7150000 + 447 447 1 0.0000000 2.6790000 13.3940000 16.0730000 + 448 448 1 0.0000000 2.6790000 13.3940000 21.4310000 + 449 449 1 0.0000000 2.6790000 13.3940000 26.7880000 + 450 450 1 0.0000000 2.6790000 13.3940000 32.1460000 + 451 451 1 0.0000000 2.6790000 18.7520000 5.3580000 + 452 452 1 0.0000000 2.6790000 18.7520000 10.7150000 + 453 453 1 0.0000000 2.6790000 18.7520000 16.0730000 + 454 454 1 0.0000000 2.6790000 18.7520000 21.4310000 + 455 455 1 0.0000000 2.6790000 18.7520000 26.7880000 + 456 456 1 0.0000000 2.6790000 18.7520000 32.1460000 + 457 457 1 0.0000000 2.6790000 24.1090000 5.3580000 + 458 458 1 0.0000000 2.6790000 24.1090000 10.7150000 + 459 459 1 0.0000000 2.6790000 24.1090000 16.0730000 + 460 460 1 0.0000000 2.6790000 24.1090000 21.4310000 + 461 461 1 0.0000000 2.6790000 24.1090000 26.7880000 + 462 462 1 0.0000000 2.6790000 24.1090000 32.1460000 + 463 463 1 0.0000000 2.6790000 29.4670000 5.3580000 + 464 464 1 0.0000000 2.6790000 29.4670000 10.7150000 + 465 465 1 0.0000000 2.6790000 29.4670000 16.0730000 + 466 466 1 0.0000000 2.6790000 29.4670000 21.4310000 + 467 467 1 0.0000000 2.6790000 29.4670000 26.7880000 + 468 468 1 0.0000000 2.6790000 29.4670000 32.1460000 + 469 469 1 0.0000000 8.0360000 2.6790000 5.3580000 + 470 470 1 0.0000000 8.0360000 2.6790000 10.7150000 + 471 471 1 0.0000000 8.0360000 2.6790000 16.0730000 + 472 472 1 0.0000000 8.0360000 2.6790000 21.4310000 + 473 473 1 0.0000000 8.0360000 2.6790000 26.7880000 + 474 474 1 0.0000000 8.0360000 2.6790000 32.1460000 + 475 475 1 0.0000000 8.0360000 8.0360000 5.3580000 + 476 476 1 0.0000000 8.0360000 8.0360000 10.7150000 + 477 477 1 0.0000000 8.0360000 8.0360000 16.0730000 + 478 478 1 0.0000000 8.0360000 8.0360000 21.4310000 + 479 479 1 0.0000000 8.0360000 8.0360000 26.7880000 + 480 480 1 0.0000000 8.0360000 8.0360000 32.1460000 + 481 481 1 0.0000000 8.0360000 13.3940000 5.3580000 + 482 482 1 0.0000000 8.0360000 13.3940000 10.7150000 + 483 483 1 0.0000000 8.0360000 13.3940000 16.0730000 + 484 484 1 0.0000000 8.0360000 13.3940000 21.4310000 + 485 485 1 0.0000000 8.0360000 13.3940000 26.7880000 + 486 486 1 0.0000000 8.0360000 13.3940000 32.1460000 + 487 487 1 0.0000000 8.0360000 18.7520000 5.3580000 + 488 488 1 0.0000000 8.0360000 18.7520000 10.7150000 + 489 489 1 0.0000000 8.0360000 18.7520000 16.0730000 + 490 490 1 0.0000000 8.0360000 18.7520000 21.4310000 + 491 491 1 0.0000000 8.0360000 18.7520000 26.7880000 + 492 492 1 0.0000000 8.0360000 18.7520000 32.1460000 + 493 493 1 0.0000000 8.0360000 24.1090000 5.3580000 + 494 494 1 0.0000000 8.0360000 24.1090000 10.7150000 + 495 495 1 0.0000000 8.0360000 24.1090000 16.0730000 + 496 496 1 0.0000000 8.0360000 24.1090000 21.4310000 + 497 497 1 0.0000000 8.0360000 24.1090000 26.7880000 + 498 498 1 0.0000000 8.0360000 24.1090000 32.1460000 + 499 499 1 0.0000000 8.0360000 29.4670000 5.3580000 + 500 500 1 0.0000000 8.0360000 29.4670000 10.7150000 + 501 501 1 0.0000000 8.0360000 29.4670000 16.0730000 + 502 502 1 0.0000000 8.0360000 29.4670000 21.4310000 + 503 503 1 0.0000000 8.0360000 29.4670000 26.7880000 + 504 504 1 0.0000000 8.0360000 29.4670000 32.1460000 + 505 505 1 0.0000000 13.3940000 2.6790000 5.3580000 + 506 506 1 0.0000000 13.3940000 2.6790000 10.7150000 + 507 507 1 0.0000000 13.3940000 2.6790000 16.0730000 + 508 508 1 0.0000000 13.3940000 2.6790000 21.4310000 + 509 509 1 0.0000000 13.3940000 2.6790000 26.7880000 + 510 510 1 0.0000000 13.3940000 2.6790000 32.1460000 + 511 511 1 0.0000000 13.3940000 8.0360000 5.3580000 + 512 512 1 0.0000000 13.3940000 8.0360000 10.7150000 + 513 513 1 0.0000000 13.3940000 8.0360000 16.0730000 + 514 514 1 0.0000000 13.3940000 8.0360000 21.4310000 + 515 515 1 0.0000000 13.3940000 8.0360000 26.7880000 + 516 516 1 0.0000000 13.3940000 8.0360000 32.1460000 + 517 517 1 0.0000000 13.3940000 13.3940000 5.3580000 + 518 518 1 0.0000000 13.3940000 13.3940000 10.7150000 + 519 519 1 0.0000000 13.3940000 13.3940000 16.0730000 + 520 520 1 0.0000000 13.3940000 13.3940000 21.4310000 + 521 521 1 0.0000000 13.3940000 13.3940000 26.7880000 + 522 522 1 0.0000000 13.3940000 13.3940000 32.1460000 + 523 523 1 0.0000000 13.3940000 18.7520000 5.3580000 + 524 524 1 0.0000000 13.3940000 18.7520000 10.7150000 + 525 525 1 0.0000000 13.3940000 18.7520000 16.0730000 + 526 526 1 0.0000000 13.3940000 18.7520000 21.4310000 + 527 527 1 0.0000000 13.3940000 18.7520000 26.7880000 + 528 528 1 0.0000000 13.3940000 18.7520000 32.1460000 + 529 529 1 0.0000000 13.3940000 24.1090000 5.3580000 + 530 530 1 0.0000000 13.3940000 24.1090000 10.7150000 + 531 531 1 0.0000000 13.3940000 24.1090000 16.0730000 + 532 532 1 0.0000000 13.3940000 24.1090000 21.4310000 + 533 533 1 0.0000000 13.3940000 24.1090000 26.7880000 + 534 534 1 0.0000000 13.3940000 24.1090000 32.1460000 + 535 535 1 0.0000000 13.3940000 29.4670000 5.3580000 + 536 536 1 0.0000000 13.3940000 29.4670000 10.7150000 + 537 537 1 0.0000000 13.3940000 29.4670000 16.0730000 + 538 538 1 0.0000000 13.3940000 29.4670000 21.4310000 + 539 539 1 0.0000000 13.3940000 29.4670000 26.7880000 + 540 540 1 0.0000000 13.3940000 29.4670000 32.1460000 + 541 541 1 0.0000000 18.7520000 2.6790000 5.3580000 + 542 542 1 0.0000000 18.7520000 2.6790000 10.7150000 + 543 543 1 0.0000000 18.7520000 2.6790000 16.0730000 + 544 544 1 0.0000000 18.7520000 2.6790000 21.4310000 + 545 545 1 0.0000000 18.7520000 2.6790000 26.7880000 + 546 546 1 0.0000000 18.7520000 2.6790000 32.1460000 + 547 547 1 0.0000000 18.7520000 8.0360000 5.3580000 + 548 548 1 0.0000000 18.7520000 8.0360000 10.7150000 + 549 549 1 0.0000000 18.7520000 8.0360000 16.0730000 + 550 550 1 0.0000000 18.7520000 8.0360000 21.4310000 + 551 551 1 0.0000000 18.7520000 8.0360000 26.7880000 + 552 552 1 0.0000000 18.7520000 8.0360000 32.1460000 + 553 553 1 0.0000000 18.7520000 13.3940000 5.3580000 + 554 554 1 0.0000000 18.7520000 13.3940000 10.7150000 + 555 555 1 0.0000000 18.7520000 13.3940000 16.0730000 + 556 556 1 0.0000000 18.7520000 13.3940000 21.4310000 + 557 557 1 0.0000000 18.7520000 13.3940000 26.7880000 + 558 558 1 0.0000000 18.7520000 13.3940000 32.1460000 + 559 559 1 0.0000000 18.7520000 18.7520000 5.3580000 + 560 560 1 0.0000000 18.7520000 18.7520000 10.7150000 + 561 561 1 0.0000000 18.7520000 18.7520000 16.0730000 + 562 562 1 0.0000000 18.7520000 18.7520000 21.4310000 + 563 563 1 0.0000000 18.7520000 18.7520000 26.7880000 + 564 564 1 0.0000000 18.7520000 18.7520000 32.1460000 + 565 565 1 0.0000000 18.7520000 24.1090000 5.3580000 + 566 566 1 0.0000000 18.7520000 24.1090000 10.7150000 + 567 567 1 0.0000000 18.7520000 24.1090000 16.0730000 + 568 568 1 0.0000000 18.7520000 24.1090000 21.4310000 + 569 569 1 0.0000000 18.7520000 24.1090000 26.7880000 + 570 570 1 0.0000000 18.7520000 24.1090000 32.1460000 + 571 571 1 0.0000000 18.7520000 29.4670000 5.3580000 + 572 572 1 0.0000000 18.7520000 29.4670000 10.7150000 + 573 573 1 0.0000000 18.7520000 29.4670000 16.0730000 + 574 574 1 0.0000000 18.7520000 29.4670000 21.4310000 + 575 575 1 0.0000000 18.7520000 29.4670000 26.7880000 + 576 576 1 0.0000000 18.7520000 29.4670000 32.1460000 + 577 577 1 0.0000000 24.1090000 2.6790000 5.3580000 + 578 578 1 0.0000000 24.1090000 2.6790000 10.7150000 + 579 579 1 0.0000000 24.1090000 2.6790000 16.0730000 + 580 580 1 0.0000000 24.1090000 2.6790000 21.4310000 + 581 581 1 0.0000000 24.1090000 2.6790000 26.7880000 + 582 582 1 0.0000000 24.1090000 2.6790000 32.1460000 + 583 583 1 0.0000000 24.1090000 8.0360000 5.3580000 + 584 584 1 0.0000000 24.1090000 8.0360000 10.7150000 + 585 585 1 0.0000000 24.1090000 8.0360000 16.0730000 + 586 586 1 0.0000000 24.1090000 8.0360000 21.4310000 + 587 587 1 0.0000000 24.1090000 8.0360000 26.7880000 + 588 588 1 0.0000000 24.1090000 8.0360000 32.1460000 + 589 589 1 0.0000000 24.1090000 13.3940000 5.3580000 + 590 590 1 0.0000000 24.1090000 13.3940000 10.7150000 + 591 591 1 0.0000000 24.1090000 13.3940000 16.0730000 + 592 592 1 0.0000000 24.1090000 13.3940000 21.4310000 + 593 593 1 0.0000000 24.1090000 13.3940000 26.7880000 + 594 594 1 0.0000000 24.1090000 13.3940000 32.1460000 + 595 595 1 0.0000000 24.1090000 18.7520000 5.3580000 + 596 596 1 0.0000000 24.1090000 18.7520000 10.7150000 + 597 597 1 0.0000000 24.1090000 18.7520000 16.0730000 + 598 598 1 0.0000000 24.1090000 18.7520000 21.4310000 + 599 599 1 0.0000000 24.1090000 18.7520000 26.7880000 + 600 600 1 0.0000000 24.1090000 18.7520000 32.1460000 + 601 601 1 0.0000000 24.1090000 24.1090000 5.3580000 + 602 602 1 0.0000000 24.1090000 24.1090000 10.7150000 + 603 603 1 0.0000000 24.1090000 24.1090000 16.0730000 + 604 604 1 0.0000000 24.1090000 24.1090000 21.4310000 + 605 605 1 0.0000000 24.1090000 24.1090000 26.7880000 + 606 606 1 0.0000000 24.1090000 24.1090000 32.1460000 + 607 607 1 0.0000000 24.1090000 29.4670000 5.3580000 + 608 608 1 0.0000000 24.1090000 29.4670000 10.7150000 + 609 609 1 0.0000000 24.1090000 29.4670000 16.0730000 + 610 610 1 0.0000000 24.1090000 29.4670000 21.4310000 + 611 611 1 0.0000000 24.1090000 29.4670000 26.7880000 + 612 612 1 0.0000000 24.1090000 29.4670000 32.1460000 + 613 613 1 0.0000000 29.4670000 2.6790000 5.3580000 + 614 614 1 0.0000000 29.4670000 2.6790000 10.7150000 + 615 615 1 0.0000000 29.4670000 2.6790000 16.0730000 + 616 616 1 0.0000000 29.4670000 2.6790000 21.4310000 + 617 617 1 0.0000000 29.4670000 2.6790000 26.7880000 + 618 618 1 0.0000000 29.4670000 2.6790000 32.1460000 + 619 619 1 0.0000000 29.4670000 8.0360000 5.3580000 + 620 620 1 0.0000000 29.4670000 8.0360000 10.7150000 + 621 621 1 0.0000000 29.4670000 8.0360000 16.0730000 + 622 622 1 0.0000000 29.4670000 8.0360000 21.4310000 + 623 623 1 0.0000000 29.4670000 8.0360000 26.7880000 + 624 624 1 0.0000000 29.4670000 8.0360000 32.1460000 + 625 625 1 0.0000000 29.4670000 13.3940000 5.3580000 + 626 626 1 0.0000000 29.4670000 13.3940000 10.7150000 + 627 627 1 0.0000000 29.4670000 13.3940000 16.0730000 + 628 628 1 0.0000000 29.4670000 13.3940000 21.4310000 + 629 629 1 0.0000000 29.4670000 13.3940000 26.7880000 + 630 630 1 0.0000000 29.4670000 13.3940000 32.1460000 + 631 631 1 0.0000000 29.4670000 18.7520000 5.3580000 + 632 632 1 0.0000000 29.4670000 18.7520000 10.7150000 + 633 633 1 0.0000000 29.4670000 18.7520000 16.0730000 + 634 634 1 0.0000000 29.4670000 18.7520000 21.4310000 + 635 635 1 0.0000000 29.4670000 18.7520000 26.7880000 + 636 636 1 0.0000000 29.4670000 18.7520000 32.1460000 + 637 637 1 0.0000000 29.4670000 24.1090000 5.3580000 + 638 638 1 0.0000000 29.4670000 24.1090000 10.7150000 + 639 639 1 0.0000000 29.4670000 24.1090000 16.0730000 + 640 640 1 0.0000000 29.4670000 24.1090000 21.4310000 + 641 641 1 0.0000000 29.4670000 24.1090000 26.7880000 + 642 642 1 0.0000000 29.4670000 24.1090000 32.1460000 + 643 643 1 0.0000000 29.4670000 29.4670000 5.3580000 + 644 644 1 0.0000000 29.4670000 29.4670000 10.7150000 + 645 645 1 0.0000000 29.4670000 29.4670000 16.0730000 + 646 646 1 0.0000000 29.4670000 29.4670000 21.4310000 + 647 647 1 0.0000000 29.4670000 29.4670000 26.7880000 + 648 648 1 0.0000000 29.4670000 29.4670000 32.1460000 + 649 649 1 0.0000000 0.0000000 5.3580000 5.3580000 + 650 650 1 0.0000000 0.0000000 5.3580000 10.7150000 + 651 651 1 0.0000000 0.0000000 5.3580000 16.0730000 + 652 652 1 0.0000000 0.0000000 5.3580000 21.4310000 + 653 653 1 0.0000000 0.0000000 5.3580000 26.7880000 + 654 654 1 0.0000000 0.0000000 5.3580000 32.1460000 + 655 655 1 0.0000000 0.0000000 10.7150000 5.3580000 + 656 656 1 0.0000000 0.0000000 10.7150000 10.7150000 + 657 657 1 0.0000000 0.0000000 10.7150000 16.0730000 + 658 658 1 0.0000000 0.0000000 10.7150000 21.4310000 + 659 659 1 0.0000000 0.0000000 10.7150000 26.7880000 + 660 660 1 0.0000000 0.0000000 10.7150000 32.1460000 + 661 661 1 0.0000000 0.0000000 16.0730000 5.3580000 + 662 662 1 0.0000000 0.0000000 16.0730000 10.7150000 + 663 663 1 0.0000000 0.0000000 16.0730000 16.0730000 + 664 664 1 0.0000000 0.0000000 16.0730000 21.4310000 + 665 665 1 0.0000000 0.0000000 16.0730000 26.7880000 + 666 666 1 0.0000000 0.0000000 16.0730000 32.1460000 + 667 667 1 0.0000000 0.0000000 21.4310000 5.3580000 + 668 668 1 0.0000000 0.0000000 21.4310000 10.7150000 + 669 669 1 0.0000000 0.0000000 21.4310000 16.0730000 + 670 670 1 0.0000000 0.0000000 21.4310000 21.4310000 + 671 671 1 0.0000000 0.0000000 21.4310000 26.7880000 + 672 672 1 0.0000000 0.0000000 21.4310000 32.1460000 + 673 673 1 0.0000000 0.0000000 26.7880000 5.3580000 + 674 674 1 0.0000000 0.0000000 26.7880000 10.7150000 + 675 675 1 0.0000000 0.0000000 26.7880000 16.0730000 + 676 676 1 0.0000000 0.0000000 26.7880000 21.4310000 + 677 677 1 0.0000000 0.0000000 26.7880000 26.7880000 + 678 678 1 0.0000000 0.0000000 26.7880000 32.1460000 + 679 679 1 0.0000000 0.0000000 32.1460000 5.3580000 + 680 680 1 0.0000000 0.0000000 32.1460000 10.7150000 + 681 681 1 0.0000000 0.0000000 32.1460000 16.0730000 + 682 682 1 0.0000000 0.0000000 32.1460000 21.4310000 + 683 683 1 0.0000000 0.0000000 32.1460000 26.7880000 + 684 684 1 0.0000000 0.0000000 32.1460000 32.1460000 + 685 685 1 0.0000000 5.3580000 5.3580000 5.3580000 + 686 686 1 0.0000000 5.3580000 5.3580000 10.7150000 + 687 687 1 0.0000000 5.3580000 5.3580000 16.0730000 + 688 688 1 0.0000000 5.3580000 5.3580000 21.4310000 + 689 689 1 0.0000000 5.3580000 5.3580000 26.7880000 + 690 690 1 0.0000000 5.3580000 5.3580000 32.1460000 + 691 691 1 0.0000000 5.3580000 10.7150000 5.3580000 + 692 692 1 0.0000000 5.3580000 10.7150000 10.7150000 + 693 693 1 0.0000000 5.3580000 10.7150000 16.0730000 + 694 694 1 0.0000000 5.3580000 10.7150000 21.4310000 + 695 695 1 0.0000000 5.3580000 10.7150000 26.7880000 + 696 696 1 0.0000000 5.3580000 10.7150000 32.1460000 + 697 697 1 0.0000000 5.3580000 16.0730000 5.3580000 + 698 698 1 0.0000000 5.3580000 16.0730000 10.7150000 + 699 699 1 0.0000000 5.3580000 16.0730000 16.0730000 + 700 700 1 0.0000000 5.3580000 16.0730000 21.4310000 + 701 701 1 0.0000000 5.3580000 16.0730000 26.7880000 + 702 702 1 0.0000000 5.3580000 16.0730000 32.1460000 + 703 703 1 0.0000000 5.3580000 21.4310000 5.3580000 + 704 704 1 0.0000000 5.3580000 21.4310000 10.7150000 + 705 705 1 0.0000000 5.3580000 21.4310000 16.0730000 + 706 706 1 0.0000000 5.3580000 21.4310000 21.4310000 + 707 707 1 0.0000000 5.3580000 21.4310000 26.7880000 + 708 708 1 0.0000000 5.3580000 21.4310000 32.1460000 + 709 709 1 0.0000000 5.3580000 26.7880000 5.3580000 + 710 710 1 0.0000000 5.3580000 26.7880000 10.7150000 + 711 711 1 0.0000000 5.3580000 26.7880000 16.0730000 + 712 712 1 0.0000000 5.3580000 26.7880000 21.4310000 + 713 713 1 0.0000000 5.3580000 26.7880000 26.7880000 + 714 714 1 0.0000000 5.3580000 26.7880000 32.1460000 + 715 715 1 0.0000000 5.3580000 32.1460000 5.3580000 + 716 716 1 0.0000000 5.3580000 32.1460000 10.7150000 + 717 717 1 0.0000000 5.3580000 32.1460000 16.0730000 + 718 718 1 0.0000000 5.3580000 32.1460000 21.4310000 + 719 719 1 0.0000000 5.3580000 32.1460000 26.7880000 + 720 720 1 0.0000000 5.3580000 32.1460000 32.1460000 + 721 721 1 0.0000000 10.7150000 5.3580000 5.3580000 + 722 722 1 0.0000000 10.7150000 5.3580000 10.7150000 + 723 723 1 0.0000000 10.7150000 5.3580000 16.0730000 + 724 724 1 0.0000000 10.7150000 5.3580000 21.4310000 + 725 725 1 0.0000000 10.7150000 5.3580000 26.7880000 + 726 726 1 0.0000000 10.7150000 5.3580000 32.1460000 + 727 727 1 0.0000000 10.7150000 10.7150000 5.3580000 + 728 728 1 0.0000000 10.7150000 10.7150000 10.7150000 + 729 729 1 0.0000000 10.7150000 10.7150000 16.0730000 + 730 730 1 0.0000000 10.7150000 10.7150000 21.4310000 + 731 731 1 0.0000000 10.7150000 10.7150000 26.7880000 + 732 732 1 0.0000000 10.7150000 10.7150000 32.1460000 + 733 733 1 0.0000000 10.7150000 16.0730000 5.3580000 + 734 734 1 0.0000000 10.7150000 16.0730000 10.7150000 + 735 735 1 0.0000000 10.7150000 16.0730000 16.0730000 + 736 736 1 0.0000000 10.7150000 16.0730000 21.4310000 + 737 737 1 0.0000000 10.7150000 16.0730000 26.7880000 + 738 738 1 0.0000000 10.7150000 16.0730000 32.1460000 + 739 739 1 0.0000000 10.7150000 21.4310000 5.3580000 + 740 740 1 0.0000000 10.7150000 21.4310000 10.7150000 + 741 741 1 0.0000000 10.7150000 21.4310000 16.0730000 + 742 742 1 0.0000000 10.7150000 21.4310000 21.4310000 + 743 743 1 0.0000000 10.7150000 21.4310000 26.7880000 + 744 744 1 0.0000000 10.7150000 21.4310000 32.1460000 + 745 745 1 0.0000000 10.7150000 26.7880000 5.3580000 + 746 746 1 0.0000000 10.7150000 26.7880000 10.7150000 + 747 747 1 0.0000000 10.7150000 26.7880000 16.0730000 + 748 748 1 0.0000000 10.7150000 26.7880000 21.4310000 + 749 749 1 0.0000000 10.7150000 26.7880000 26.7880000 + 750 750 1 0.0000000 10.7150000 26.7880000 32.1460000 + 751 751 1 0.0000000 10.7150000 32.1460000 5.3580000 + 752 752 1 0.0000000 10.7150000 32.1460000 10.7150000 + 753 753 1 0.0000000 10.7150000 32.1460000 16.0730000 + 754 754 1 0.0000000 10.7150000 32.1460000 21.4310000 + 755 755 1 0.0000000 10.7150000 32.1460000 26.7880000 + 756 756 1 0.0000000 10.7150000 32.1460000 32.1460000 + 757 757 1 0.0000000 16.0730000 5.3580000 5.3580000 + 758 758 1 0.0000000 16.0730000 5.3580000 10.7150000 + 759 759 1 0.0000000 16.0730000 5.3580000 16.0730000 + 760 760 1 0.0000000 16.0730000 5.3580000 21.4310000 + 761 761 1 0.0000000 16.0730000 5.3580000 26.7880000 + 762 762 1 0.0000000 16.0730000 5.3580000 32.1460000 + 763 763 1 0.0000000 16.0730000 10.7150000 5.3580000 + 764 764 1 0.0000000 16.0730000 10.7150000 10.7150000 + 765 765 1 0.0000000 16.0730000 10.7150000 16.0730000 + 766 766 1 0.0000000 16.0730000 10.7150000 21.4310000 + 767 767 1 0.0000000 16.0730000 10.7150000 26.7880000 + 768 768 1 0.0000000 16.0730000 10.7150000 32.1460000 + 769 769 1 0.0000000 16.0730000 16.0730000 5.3580000 + 770 770 1 0.0000000 16.0730000 16.0730000 10.7150000 + 771 771 1 0.0000000 16.0730000 16.0730000 16.0730000 + 772 772 1 0.0000000 16.0730000 16.0730000 21.4310000 + 773 773 1 0.0000000 16.0730000 16.0730000 26.7880000 + 774 774 1 0.0000000 16.0730000 16.0730000 32.1460000 + 775 775 1 0.0000000 16.0730000 21.4310000 5.3580000 + 776 776 1 0.0000000 16.0730000 21.4310000 10.7150000 + 777 777 1 0.0000000 16.0730000 21.4310000 16.0730000 + 778 778 1 0.0000000 16.0730000 21.4310000 21.4310000 + 779 779 1 0.0000000 16.0730000 21.4310000 26.7880000 + 780 780 1 0.0000000 16.0730000 21.4310000 32.1460000 + 781 781 1 0.0000000 16.0730000 26.7880000 5.3580000 + 782 782 1 0.0000000 16.0730000 26.7880000 10.7150000 + 783 783 1 0.0000000 16.0730000 26.7880000 16.0730000 + 784 784 1 0.0000000 16.0730000 26.7880000 21.4310000 + 785 785 1 0.0000000 16.0730000 26.7880000 26.7880000 + 786 786 1 0.0000000 16.0730000 26.7880000 32.1460000 + 787 787 1 0.0000000 16.0730000 32.1460000 5.3580000 + 788 788 1 0.0000000 16.0730000 32.1460000 10.7150000 + 789 789 1 0.0000000 16.0730000 32.1460000 16.0730000 + 790 790 1 0.0000000 16.0730000 32.1460000 21.4310000 + 791 791 1 0.0000000 16.0730000 32.1460000 26.7880000 + 792 792 1 0.0000000 16.0730000 32.1460000 32.1460000 + 793 793 1 0.0000000 21.4310000 5.3580000 5.3580000 + 794 794 1 0.0000000 21.4310000 5.3580000 10.7150000 + 795 795 1 0.0000000 21.4310000 5.3580000 16.0730000 + 796 796 1 0.0000000 21.4310000 5.3580000 21.4310000 + 797 797 1 0.0000000 21.4310000 5.3580000 26.7880000 + 798 798 1 0.0000000 21.4310000 5.3580000 32.1460000 + 799 799 1 0.0000000 21.4310000 10.7150000 5.3580000 + 800 800 1 0.0000000 21.4310000 10.7150000 10.7150000 + 801 801 1 0.0000000 21.4310000 10.7150000 16.0730000 + 802 802 1 0.0000000 21.4310000 10.7150000 21.4310000 + 803 803 1 0.0000000 21.4310000 10.7150000 26.7880000 + 804 804 1 0.0000000 21.4310000 10.7150000 32.1460000 + 805 805 1 0.0000000 21.4310000 16.0730000 5.3580000 + 806 806 1 0.0000000 21.4310000 16.0730000 10.7150000 + 807 807 1 0.0000000 21.4310000 16.0730000 16.0730000 + 808 808 1 0.0000000 21.4310000 16.0730000 21.4310000 + 809 809 1 0.0000000 21.4310000 16.0730000 26.7880000 + 810 810 1 0.0000000 21.4310000 16.0730000 32.1460000 + 811 811 1 0.0000000 21.4310000 21.4310000 5.3580000 + 812 812 1 0.0000000 21.4310000 21.4310000 10.7150000 + 813 813 1 0.0000000 21.4310000 21.4310000 16.0730000 + 814 814 1 0.0000000 21.4310000 21.4310000 21.4310000 + 815 815 1 0.0000000 21.4310000 21.4310000 26.7880000 + 816 816 1 0.0000000 21.4310000 21.4310000 32.1460000 + 817 817 1 0.0000000 21.4310000 26.7880000 5.3580000 + 818 818 1 0.0000000 21.4310000 26.7880000 10.7150000 + 819 819 1 0.0000000 21.4310000 26.7880000 16.0730000 + 820 820 1 0.0000000 21.4310000 26.7880000 21.4310000 + 821 821 1 0.0000000 21.4310000 26.7880000 26.7880000 + 822 822 1 0.0000000 21.4310000 26.7880000 32.1460000 + 823 823 1 0.0000000 21.4310000 32.1460000 5.3580000 + 824 824 1 0.0000000 21.4310000 32.1460000 10.7150000 + 825 825 1 0.0000000 21.4310000 32.1460000 16.0730000 + 826 826 1 0.0000000 21.4310000 32.1460000 21.4310000 + 827 827 1 0.0000000 21.4310000 32.1460000 26.7880000 + 828 828 1 0.0000000 21.4310000 32.1460000 32.1460000 + 829 829 1 0.0000000 26.7880000 5.3580000 5.3580000 + 830 830 1 0.0000000 26.7880000 5.3580000 10.7150000 + 831 831 1 0.0000000 26.7880000 5.3580000 16.0730000 + 832 832 1 0.0000000 26.7880000 5.3580000 21.4310000 + 833 833 1 0.0000000 26.7880000 5.3580000 26.7880000 + 834 834 1 0.0000000 26.7880000 5.3580000 32.1460000 + 835 835 1 0.0000000 26.7880000 10.7150000 5.3580000 + 836 836 1 0.0000000 26.7880000 10.7150000 10.7150000 + 837 837 1 0.0000000 26.7880000 10.7150000 16.0730000 + 838 838 1 0.0000000 26.7880000 10.7150000 21.4310000 + 839 839 1 0.0000000 26.7880000 10.7150000 26.7880000 + 840 840 1 0.0000000 26.7880000 10.7150000 32.1460000 + 841 841 1 0.0000000 26.7880000 16.0730000 5.3580000 + 842 842 1 0.0000000 26.7880000 16.0730000 10.7150000 + 843 843 1 0.0000000 26.7880000 16.0730000 16.0730000 + 844 844 1 0.0000000 26.7880000 16.0730000 21.4310000 + 845 845 1 0.0000000 26.7880000 16.0730000 26.7880000 + 846 846 1 0.0000000 26.7880000 16.0730000 32.1460000 + 847 847 1 0.0000000 26.7880000 21.4310000 5.3580000 + 848 848 1 0.0000000 26.7880000 21.4310000 10.7150000 + 849 849 1 0.0000000 26.7880000 21.4310000 16.0730000 + 850 850 1 0.0000000 26.7880000 21.4310000 21.4310000 + 851 851 1 0.0000000 26.7880000 21.4310000 26.7880000 + 852 852 1 0.0000000 26.7880000 21.4310000 32.1460000 + 853 853 1 0.0000000 26.7880000 26.7880000 5.3580000 + 854 854 1 0.0000000 26.7880000 26.7880000 10.7150000 + 855 855 1 0.0000000 26.7880000 26.7880000 16.0730000 + 856 856 1 0.0000000 26.7880000 26.7880000 21.4310000 + 857 857 1 0.0000000 26.7880000 26.7880000 26.7880000 + 858 858 1 0.0000000 26.7880000 26.7880000 32.1460000 + 859 859 1 0.0000000 26.7880000 32.1460000 5.3580000 + 860 860 1 0.0000000 26.7880000 32.1460000 10.7150000 + 861 861 1 0.0000000 26.7880000 32.1460000 16.0730000 + 862 862 1 0.0000000 26.7880000 32.1460000 21.4310000 + 863 863 1 0.0000000 26.7880000 32.1460000 26.7880000 + 864 864 1 0.0000000 26.7880000 32.1460000 32.1460000 + diff --git a/examples/python/gjf_python/ff-argon.lmp b/examples/python/gjf_python/ff-argon.lmp new file mode 100644 index 0000000000..b6f7bc931a --- /dev/null +++ b/examples/python/gjf_python/ff-argon.lmp @@ -0,0 +1,20 @@ +############################# +#Atoms types - mass - charge# +############################# +#@ 1 atom types #!THIS LINE IS NECESSARY DON'T SPEND HOURS FINDING THAT OUT!# + +variable Ar equal 1 + +############# +#Atom Masses# +############# + +mass ${Ar} 39.903 + +########################### +#Pair Potentials - Tersoff# +########################### + +pair_style lj/cubic +pair_coeff * * 0.0102701 3.42 + diff --git a/examples/python/gjf_python/gjf.py b/examples/python/gjf_python/gjf.py new file mode 100644 index 0000000000..37fc28bb79 --- /dev/null +++ b/examples/python/gjf_python/gjf.py @@ -0,0 +1,180 @@ +"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" + +from mpi4py import MPI +from lammps import lammps +import lammps_tools as lt +import numpy as np + +comm = MPI.COMM_WORLD +rank = comm.Get_rank() + +""" LAMMPS VARIABLES """ + +# new file or restart +run_no = 0 + +# data files +infile = "argon.lmp" +restart_file = "final_restart.{}".format(run_no) +ff_file = "ff-argon.lmp" +outfile = "output.dat" + +# write final_restart +write_final_restart = False + +# random numbers +seed0 = 2357 +seed1 = 26588 +seed2 = 10669 + +# MD Parameters +# number of steps +nsteps = 50000 +# timestep +# dt = 0.001 +# starting simulation temp +temp_start = 10 +# final simulation temp +temp_final = 10 +# relaxation time +trel = 1 +# trajectory frequency +ntraj = 0 + +# Ensemble 0 = GJF u, 1 = GJF v, 2 = Nose-Hoover, 3 = Langevin, 4 = BDP (Currently all NVT) +ensemble = 0 + +# Output Parameters +nthermo = 200 +nout = int(nsteps / nthermo) # Important + +# output to screen and log file? +lammps_output = False +# Lammps Thermo +thermo = False + +python_output = True + +# Write output to file? +write_output = False + +if write_output is True: + data = open("{}".format(outfile), "w") + +if python_output is True: + if rank == 0: + print("dt, temp, ke, fke, pe, fpe") + +for j in range(20): + + # timestep + dt = 0.005*(j+1) + + if lammps_output is True: + lmp = lammps() + else: + lmp = lammps(cmdargs=["-screen", "none", "-log", "none"]) + + lmp.command("atom_style full") + lmp.command("units metal") + lmp.command("processors * * *") + lmp.command("neighbor 1 bin") + lmp.command("boundary p p p") + + if run_no is 0: + lmp.command("read_data {}".format(infile)) + else: + lmp.command("read_restart final_restart".format(run_no-1)) + + if thermo is True: + lmp.command("thermo_style custom time temp pe ke press vol cpu") + lmp.command("thermo {}".format(nthermo)) + lmp.command("thermo_modify flush yes") + + lmp.file("{}".format(ff_file)) + lmp.command("timestep {}".format(dt)) + + # get_per_atom_compute example with dim of two and within a group + # lmp.command("region rand block 5 20 5 20 5 20") + # lmp.command("group rand region rand") + # lmp.command("compute x rand property/atom x y") + # test = get_per_atom_compute(comm, lmp, "x", 2, group="rand") + + lmp.command("compute ke all ke/atom") + + lmp.command("compute pe all pe") + + if ntraj != 0: + lmp.command("dump 1 all dcd {} trajectory.dcd".format(ntraj)) + lmp.command("dump_modify 1 unwrap yes") + + if run_no == 0: + lmp.command("velocity all create {} {} mom yes dist gaussian".format(temp_start, seed0)) + lmp.command("fix nve all nve") + + if ensemble == 0: + # gjf u + lmp.command("fix lang all langevin {} {} {} {} gjf yes halfstep yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 1: + # gjf v + lmp.command("fix lang all langevin {} {} {} {} gjf yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 2: + # NH + lmp.command("fix nvt all nvt temp {} {} {}".format( + temp_start, temp_final, trel)) + elif ensemble == 3: + # lang + lmp.command("fix lang all langevin {} {} {} {} tally yes zero yes".format( + temp_start, temp_final, trel, seed1)) + elif ensemble == 4: + # BDP + lmp.command("fix stoch all temp/csvr {} {} {} {}".format( + temp_start, temp_final, trel, seed1)) + + natoms = lmp.extract_global("natoms", 0) + nlocal = lmp.extract_global("nlocal", 0) + ke_sum = lt.get_per_atom_compute(comm, lmp, "ke") + ke_2 = ke_sum**2 + pe_sum = 0 + pe_2 = 0 + temp_sum = 0 + + for i in range(nout): + nlocal = lmp.extract_global("nlocal", 0) + lmp.command("run {} pre no post no".format(nthermo)) + temp = lmp.extract_compute("thermo_temp", 0, 0) + ke = lt.get_per_atom_compute(comm, lmp, "ke") + pe = lmp.extract_compute("pe", 0, 0) + ke_sum += ke + ke_2 += ke**2 + pe_sum += pe + pe_2 += pe**2 + temp_sum += temp + + if python_output is True: + if rank == 0: + print("Time: {:.6f}, Temp: {:.6f}, KE: {:.6f}, PE: {:.6f}".format( + i*nthermo*dt, temp, ke.sum(), pe)) + + if write_final_restart is True: + lmp.command("write_restart {}".format(restart_file)) + + if rank == 0: + ke = ke_sum.sum() / (nout + 1) + fke = (np.sqrt((ke_2 - ke_sum ** 2 / (nout + 1)) / (nout + 1))).sum() + pe = pe_sum / nout + fpe = np.sqrt((pe_2 - pe_sum ** 2 / nout) / nout) + temp = temp_sum / nout + + if python_output is True: + print(dt, temp, ke, fke, pe, fpe) + + if write_output is True: + data.write("{:.6f} {:.6f} {:.6f} {:.6f} {:.6f} {:.6f}\n".format( + dt, temp, ke, fke, pe, fpe)) + data.flush() + +if write_output is True: + data.close() diff --git a/examples/python/gjf_python/lammps_tools.py b/examples/python/gjf_python/lammps_tools.py new file mode 100644 index 0000000000..f9f25eaa28 --- /dev/null +++ b/examples/python/gjf_python/lammps_tools.py @@ -0,0 +1,78 @@ +"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" + +from mpi4py import MPI +import numpy as np +import ctypes as ctypes + +""" USEFULL LAMMPS FUNCTION """ + + +def get_nlocal(lmp): + + nlocal = lmp.extract_global("nlocal", 0) + + return nlocal + + +def get_aid(lmp, group=None): + + if group is None: + c_aid = lmp.extract_atom("id", 0) + ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_int32 * get_nlocal(lmp))) + aid = np.frombuffer(ptr.contents, dtype=np.int32) + else: + try: + c_aid = lmp.extract_variable("aid", group, 1) + ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_double * get_nlocal(lmp))) + aid = np.frombuffer(ptr.contents, dtype=np.double) + except ValueError: + lmp.command("variable aid atom id") + aid = get_aid(lmp, group) + + return aid + + +def get_per_atom_compute(comm, lmp, name, dim=1, dtype="double", group=None): + laid = get_aid(lmp, group) + nlocal = get_nlocal(lmp) + ngroup = comm.allgather(laid) + type = dim + if dim > 1: + type = 2 + for array in ngroup: + try: + aid = np.concatenate((aid, array)) + except UnboundLocalError: + aid = array + if dtype == "double": + mem_type = ctypes.c_double + elif dtype == "integer": + mem_type = ctypes.c_int + elif dtype == "bigint": + mem_type = ctypes.c_int32 + else: + print("{} not implemented".format(dtype)) + return + + tmp = lmp.extract_compute(name, 1, type) + if type == 1: + ptr = ctypes.cast(tmp, ctypes.POINTER(mem_type * nlocal)) + else: + ptr = ctypes.cast(tmp[0], ctypes.POINTER(mem_type * nlocal * dim)) + lcompute = comm.allgather(np.frombuffer(ptr.contents).reshape((-1, dim))) + for array in lcompute: + try: + compute = np.concatenate((compute, array)) + except UnboundLocalError: + compute = array + + aid = np.expand_dims(aid, axis=1) + + compute = np.concatenate((aid, compute), axis=-1) + compute = compute[compute[..., 0] != 0] + compute = compute[compute[..., 0].argsort()][..., 1:] + + if dim == 1: + compute = np.squeeze(compute, axis=-1) + + return compute \ No newline at end of file From e0454ce5809dac84d953d4ea1349546d6ce6c9c4 Mon Sep 17 00:00:00 2001 From: casievers Date: Fri, 19 Jul 2019 17:21:01 -0700 Subject: [PATCH 071/557] updated gjf in fix_langevin --- src/fix_langevin.cpp | 39 +++++++++++---------------------------- src/fix_langevin.h | 2 +- 2 files changed, 12 insertions(+), 29 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 0db60c14cf..e530a4615d 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -174,11 +174,11 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { - int mem = 6*atom->nmax*sizeof(double); - if (hsflag) mem += 3*atom->nmax*sizeof(double); - - comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); - comm->maxexchange_fix += MAX(1000, mem); + //int mem = 6*atom->nmax*sizeof(double); + //if (hsflag) mem += 3*atom->nmax*sizeof(double); +// + //comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); + //comm->maxexchange_fix += MAX(1000, mem); nvalues = 3; grow_arrays(atom->nmax); @@ -230,7 +230,6 @@ FixLangevin::~FixLangevin() int FixLangevin::setmask() { int mask = 0; - //if (gjfflag) mask |= INITIAL_INTEGRATE; if (gjfflag) mask |= POST_INTEGRATE; mask |= POST_FORCE; mask |= POST_FORCE_RESPA; @@ -319,35 +318,19 @@ void FixLangevin::setup(int vflag) post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); } - if (gjfflag && hsflag) { + if (gjfflag) { - double dt = update->dt; // update v of atoms in group - - double **v = atom->v; - double *rmass = atom->rmass; - int *type = atom->type; + double ** v = atom->v; + double **f = atom->f; int nlocal = atom->nlocal; if (igroup == atom->firstgroup) nlocal = atom->nfirst; - double boltz = force->boltz; - double mvv2e = force->mvv2e; - double ftm2v = force->ftm2v; - - double gamma2; - for (int i = 0; i < nlocal; i++) { - if (rmass) { - gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; - gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; - } else { - gamma2 = gfactor2[type[i]] * tsqrt; - } - - franprev[i][0] = gamma2*random->gaussian(); - franprev[i][1] = gamma2*random->gaussian(); - franprev[i][2] = gamma2*random->gaussian(); + f[i][0] = wildcard[i][0]; + f[i][1] = wildcard[i][1]; + f[i][2] = wildcard[i][2]; wildcard[i][0] = v[i][0]; wildcard[i][1] = v[i][1]; wildcard[i][2] = v[i][2]; diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 461d4e5140..888734de04 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -65,7 +65,7 @@ class FixLangevin : public Fix { double **flangevin; double *tforce; double **franprev; - double **lv; //lucas velocity or half-step velocity + double **lv; //2GJ velocity or half-step velocity double **wildcard; int nvalues; From f4da63287042207967a76897717eb3712925ff32 Mon Sep 17 00:00:00 2001 From: casievers Date: Mon, 22 Jul 2019 13:48:02 -0700 Subject: [PATCH 072/557] recent change to gjf tally (not working) --- examples/gjf/out.argon | 249 ---------------------------------- examples/gjf/trajectory.0.dcd | Bin 439092 -> 0 bytes src/fix_langevin.cpp | 7 +- 3 files changed, 6 insertions(+), 250 deletions(-) delete mode 100644 examples/gjf/out.argon delete mode 100644 examples/gjf/trajectory.0.dcd diff --git a/examples/gjf/out.argon b/examples/gjf/out.argon deleted file mode 100644 index 8dda569157..0000000000 --- a/examples/gjf/out.argon +++ /dev/null @@ -1,249 +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 -Reading data file ... - orthogonal box = (0 0 0) to (32.146 32.146 32.146) - 1 by 2 by 2 MPI processor grid - reading atoms ... - 864 atoms -Finding 1-2 1-3 1-4 neighbors ... - special bond factors lj: 0 0 0 - special bond factors coul: 0 0 0 - 0 = max # of 1-2 neighbors - 0 = max # of 1-3 neighbors - 0 = max # of 1-4 neighbors - 1 = max # of special neighbors -Setting up the ensembles -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -WARNING: Careful, tally is untested (src/fix_langevin.cpp:145) -Doing Molecular dynamics -Neighbor list info ... - update every 1 steps, delay 10 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.94072 - ghost atom cutoff = 6.94072 - binsize = 3.47036, bins = 10 10 10 - 1 neighbor lists, perpetual/occasional/extra = 1 0 0 - (1) pair lj/cubic, perpetual - attributes: half, newton on - pair build: half/bin/newton - stencil: half/bin/3d/newton - bin: standard -Setting up Verlet run ... - Unit style : metal - Current step : 0 - Time step : 0.12 -Per MPI rank memory allocation (min/avg/max) = 6.847 | 6.847 | 6.847 Mbytes -Time Temp PotEng TotEng Press Volume CPU - 0 10 -56.207655 -55.09214 33.340921 33218.561 0 - 24 10.156356 -55.092888 -53.959932 339.40964 33218.561 0.082175482 - 48 9.6121006 -55.07262 -54.000376 344.56765 33218.561 0.19529325 - 72 9.8187467 -55.16687 -54.071574 318.85979 33218.561 0.29643488 - 96 9.5421385 -55.151229 -54.086789 322.8842 33218.561 0.38801357 - 120 10.295035 -55.12919 -53.980763 332.00171 33218.561 0.47607262 - 144 10.331608 -55.09907 -53.946563 339.28896 33218.561 0.57389224 - 168 10.154698 -55.058246 -53.925475 349.03253 33218.561 0.65481471 - 192 9.858198 -55.127583 -54.027886 330.09298 33218.561 0.74437734 - 216 9.6658918 -55.10812 -54.029875 334.28383 33218.561 0.8278495 - 240 9.6801591 -55.102386 -54.02255 336.27242 33218.561 0.91167379 - 264 10.685658 -55.046238 -53.854237 355.0448 33218.561 1.0023789 - 288 10.387727 -55.08427 -53.925504 343.87247 33218.561 1.0960371 - 312 10.231132 -55.120428 -53.97913 333.22463 33218.561 1.2382998 - 336 10.20896 -55.075142 -53.936317 344.88438 33218.561 1.3420489 - 360 9.7876538 -55.165008 -54.07318 319.14962 33218.561 1.42782 - 384 9.9872551 -55.13881 -54.024717 327.82471 33218.561 1.5417666 - 408 9.5362734 -55.063733 -53.999947 346.50545 33218.561 1.6328366 - 432 10.262638 -55.126608 -53.981796 332.16342 33218.561 1.7242996 - 456 9.9228239 -55.122119 -54.015214 332.26261 33218.561 1.8124888 - 480 9.7026324 -55.17057 -54.088227 317.84818 33218.561 1.900233 - 504 10.028762 -55.082465 -53.963741 343.04257 33218.561 1.989605 - 528 9.8227851 -55.121222 -54.025476 332.42857 33218.561 2.0708802 - 552 10.208672 -55.100242 -53.961449 338.68109 33218.561 2.1527217 - 576 10.180849 -55.124065 -53.988376 331.29516 33218.561 2.238126 - 600 9.6467252 -55.119533 -54.043427 332.43109 33218.561 2.323443 - 624 10.041885 -55.173802 -54.053614 318.48579 33218.561 2.4046151 - 648 10.151597 -55.111725 -53.979299 334.66227 33218.561 2.4902161 - 672 9.7719111 -55.060111 -53.970039 348.55249 33218.561 2.5800372 - 696 10.476688 -55.088109 -53.919419 342.94922 33218.561 2.6731395 - 720 10.517805 -55.113604 -53.940327 335.47342 33218.561 2.760651 - 744 10.006466 -55.045085 -53.928848 353.53813 33218.561 2.8537894 - 768 10.201492 -55.081598 -53.943606 343.3206 33218.561 2.9404115 - 792 10.117738 -55.077806 -53.949157 345.31093 33218.561 3.030765 - 816 10.362288 -55.11635 -53.960421 333.9045 33218.561 3.1177356 - 840 10.204164 -55.097619 -53.959329 338.82717 33218.561 3.2091886 - 864 10.147722 -55.101372 -53.969378 338.19682 33218.561 3.3003742 - 888 9.9265037 -55.111394 -54.004077 334.08116 33218.561 3.395341 - 912 10.206403 -55.132181 -53.993642 328.89904 33218.561 3.4882881 - 936 10.28639 -55.093317 -53.945855 340.61244 33218.561 3.5764735 - 960 9.8028822 -55.078802 -53.985276 343.5904 33218.561 3.7056267 - 984 10.492755 -55.121321 -53.950839 334.62697 33218.561 3.8055611 - 1008 10.621569 -55.088588 -53.903736 343.33166 33218.561 3.9144807 - 1032 10.006729 -55.113459 -53.997193 334.43025 33218.561 4.0189888 - 1056 10.099853 -55.068035 -53.941381 347.42158 33218.561 4.1391664 - 1080 10.254232 -55.066685 -53.92281 347.15777 33218.561 4.2443953 - 1104 9.9495142 -55.13686 -54.026977 327.63107 33218.561 4.3368342 - 1128 10.377108 -55.08846 -53.930878 344.13083 33218.561 4.4287748 - 1152 10.036981 -55.114643 -53.995003 334.88053 33218.561 4.526868 - 1176 10.144779 -55.097125 -53.965459 339.698 33218.561 4.6614049 - 1200 10.075844 -55.14695 -54.022974 326.05911 33218.561 4.799835 - 1224 10.183695 -55.121716 -53.98571 332.75772 33218.561 4.8908897 - 1248 10.581369 -55.027954 -53.847587 359.06251 33218.561 4.9839788 - 1272 10.158269 -55.105173 -53.972003 337.52964 33218.561 5.0918646 - 1296 9.8776072 -55.064085 -53.962223 347.15648 33218.561 5.2291209 - 1320 10.38161 -55.118366 -53.960282 335.17767 33218.561 5.3570446 - 1344 9.9528146 -55.141937 -54.031685 326.27117 33218.561 5.4584705 - 1368 9.8024326 -55.117808 -54.024332 332.99835 33218.561 5.5557818 - 1392 10.35447 -55.110235 -53.955179 336.80412 33218.561 5.6467392 - 1416 10.199061 -55.105641 -53.96792 337.36785 33218.561 5.7476527 - 1440 9.6868779 -55.087316 -54.00673 340.9166 33218.561 5.8432207 - 1464 10.093238 -55.049436 -53.92352 352.27563 33218.561 5.9471521 - 1488 9.7578808 -55.123935 -54.035429 329.93926 33218.561 6.0495014 - 1512 10.099979 -55.205426 -54.078758 309.26166 33218.561 6.1612976 - 1536 10.172944 -55.087106 -53.952299 342.93395 33218.561 6.2506202 - 1560 10.51771 -55.107635 -53.934369 340.1967 33218.561 6.3379856 - 1584 10.044994 -55.101362 -53.980828 339.03163 33218.561 6.4362567 - 1608 9.624758 -55.146246 -54.07259 324.32486 33218.561 6.5385845 - 1632 9.9135215 -55.097278 -53.99141 338.69162 33218.561 6.6452786 - 1656 9.863681 -55.070523 -53.970214 345.84608 33218.561 6.7518212 - 1680 10.138513 -55.127065 -53.996099 330.40757 33218.561 6.8775188 - 1704 10.382237 -55.070572 -53.912417 347.074 33218.561 7.0126448 - 1728 10.72487 -55.081147 -53.884771 345.83623 33218.561 7.1384216 - 1752 9.829431 -55.131041 -54.034553 328.57652 33218.561 7.2616419 - 1776 9.9135662 -55.100556 -53.994682 336.52238 33218.561 7.4193201 - 1800 10.41873 -55.097116 -53.934891 340.24798 33218.561 7.5570544 - 1824 10.151782 -55.03231 -53.899864 357.3654 33218.561 7.6872905 - 1848 10.42307 -55.043808 -53.881099 355.71677 33218.561 7.7933885 - 1872 10.276862 -55.085016 -53.938616 344.46273 33218.561 7.8887472 - 1896 9.7681373 -55.146507 -54.056857 324.84323 33218.561 7.9977923 - 1920 9.6624824 -55.103214 -54.025349 336.06397 33218.561 8.090235 - 1944 10.153504 -55.049175 -53.916536 352.36339 33218.561 8.1923703 - 1968 10.191954 -55.098741 -53.961813 338.8667 33218.561 8.3320906 - 1992 9.92167 -55.117079 -54.010302 332.96497 33218.561 8.4774437 - 2016 9.5737281 -55.091141 -54.023178 339.41837 33218.561 8.6149527 - 2040 10.600908 -55.092717 -53.91017 342.71852 33218.561 8.7639523 - 2064 9.9214513 -55.099904 -53.993151 337.46799 33218.561 8.898087 - 2088 9.9256258 -55.082224 -53.975005 342.85042 33218.561 9.0130784 - 2112 10.345379 -55.112923 -53.95888 335.81471 33218.561 9.1422766 - 2136 9.8876649 -55.079254 -53.97627 343.05764 33218.561 9.2885707 - 2160 10.04492 -55.074876 -53.95435 344.82419 33218.561 9.3876103 - 2184 10.028705 -55.063961 -53.945244 347.70549 33218.561 9.500967 - 2208 10.412572 -55.136316 -53.974778 329.8188 33218.561 9.5900362 - 2232 10.404205 -55.09913 -53.938525 339.77542 33218.561 9.7048353 - 2256 9.5694135 -55.139021 -54.071538 326.37473 33218.561 9.8045958 - 2280 10.244745 -55.134529 -53.991713 329.19392 33218.561 9.8968908 - 2304 9.9129922 -55.116192 -54.010382 333.14326 33218.561 9.9818651 - 2328 10.167027 -55.08241 -53.948263 343.08135 33218.561 10.068683 - 2352 10.262045 -55.144327 -53.999581 327.40876 33218.561 10.155937 - 2376 10.520934 -55.073147 -53.899521 347.6998 33218.561 10.246316 - 2400 9.9628692 -55.122001 -54.010628 331.25369 33218.561 10.336833 - 2424 10.565531 -55.157113 -53.978512 325.14897 33218.561 10.452039 - 2448 10.03709 -55.096409 -53.976756 338.29607 33218.561 10.537936 - 2472 9.384311 -55.141821 -54.094987 324.23247 33218.561 10.628689 - 2496 9.8019362 -55.105685 -54.012264 335.97239 33218.561 10.717287 - 2520 10.31114 -55.078831 -53.928608 345.42395 33218.561 10.818756 - 2544 10.407237 -55.148382 -53.987439 325.94421 33218.561 10.910801 - 2568 10.257967 -55.041348 -53.897056 355.73261 33218.561 11.004221 - 2592 9.8425807 -55.139428 -54.041474 328.28096 33218.561 11.101295 - 2616 10.140697 -55.100238 -53.969028 338.76319 33218.561 11.192211 - 2640 9.7102818 -55.136288 -54.053091 326.7053 33218.561 11.280277 - 2664 10.120372 -55.128779 -53.999836 330.71707 33218.561 11.369001 - 2688 10.232537 -55.120614 -53.979159 333.35087 33218.561 11.464652 - 2712 10.032526 -55.094761 -53.975618 339.97984 33218.561 11.559387 - 2736 9.8791 -55.121998 -54.01997 332.32556 33218.561 11.649679 - 2760 9.891483 -55.120919 -54.017509 331.32614 33218.561 11.742604 - 2784 10.201053 -55.165525 -54.027582 320.39272 33218.561 11.85274 - 2808 10.238648 -55.096449 -53.954312 340.06316 33218.561 11.939782 - 2832 9.8692851 -55.068632 -53.967699 346.77535 33218.561 12.036655 - 2856 10.179976 -55.128413 -53.992822 331.5662 33218.561 12.123227 - 2880 9.7656315 -55.1468 -54.057429 324.02612 33218.561 12.213117 - 2904 9.7991628 -55.049191 -53.95608 352.45738 33218.561 12.326761 - 2928 10.581767 -55.093293 -53.912881 341.37292 33218.561 12.417633 - 2952 10.546144 -55.07452 -53.898081 347.02025 33218.561 12.52701 - 2976 9.8306008 -55.14762 -54.051002 323.45715 33218.561 12.633522 - 3000 10.033532 -55.076433 -53.957178 345.36812 33218.561 12.72627 - 3024 10.046266 -55.085775 -53.965099 342.47786 33218.561 12.816242 - 3048 10.176777 -55.133013 -53.997778 329.04144 33218.561 12.903175 - 3072 9.9778064 -55.143787 -54.030748 326.75284 33218.561 13.014329 - 3096 10.516223 -55.110144 -53.937043 336.802 33218.561 13.104673 - 3120 9.6561157 -55.138699 -54.061544 325.6652 33218.561 13.207371 - 3144 10.237043 -55.060968 -53.91901 349.44011 33218.561 13.303442 - 3168 9.9704264 -55.123073 -54.010857 332.19725 33218.561 13.391877 - 3192 10.493307 -55.144402 -53.973858 327.15485 33218.561 13.482857 - 3216 10.022171 -55.141782 -54.023794 326.08249 33218.561 13.574484 - 3240 9.6957248 -55.137865 -54.056292 326.04858 33218.561 13.671408 - 3264 9.9685299 -55.124301 -54.012297 331.9015 33218.561 13.760186 - 3288 10.413707 -55.153604 -53.99194 324.32939 33218.561 13.877604 - 3312 10.022953 -55.103422 -53.985346 337.52066 33218.561 13.977562 - 3336 10.044478 -55.110297 -53.98982 334.48379 33218.561 14.065563 - 3360 9.8593734 -55.130623 -54.030795 327.71748 33218.561 14.15952 - 3384 9.9269422 -55.107979 -54.000613 335.18173 33218.561 14.258064 - 3408 10.288049 -55.092276 -53.944629 340.71484 33218.561 14.36211 - 3432 9.9702156 -55.08732 -53.975128 341.72171 33218.561 14.452123 - 3456 10.246178 -55.091669 -53.948692 341.62844 33218.561 14.555775 - 3480 10.559292 -55.086917 -53.909012 343.70626 33218.561 14.645718 - 3504 10.652207 -55.050897 -53.862628 354.46979 33218.561 14.797422 - 3528 9.9835266 -55.0557 -53.942023 350.74747 33218.561 14.895716 - 3552 10.240934 -55.123217 -53.980825 332.26434 33218.561 15.023796 - 3576 10.406519 -55.093536 -53.932674 341.54029 33218.561 15.203252 - 3600 10.406733 -55.095168 -53.934282 341.22192 33218.561 15.303986 - 3624 9.9877484 -55.154231 -54.040083 323.55633 33218.561 15.398883 - 3648 10.391829 -55.110208 -53.950984 337.09219 33218.561 15.49042 - 3672 10.368995 -55.069591 -53.912914 346.82649 33218.561 15.582259 - 3696 10.362939 -55.109012 -53.953011 337.32216 33218.561 15.679316 - 3720 10.465254 -55.136214 -53.968799 331.22288 33218.561 15.773303 - 3744 9.8238226 -55.10114 -54.005278 338.12616 33218.561 15.86905 - 3768 10.205504 -55.101263 -53.962824 339.04196 33218.561 15.960072 - 3792 9.9589987 -55.118883 -54.007942 332.84318 33218.561 16.047055 - 3816 10.253382 -55.117513 -53.973732 334.42101 33218.561 16.148412 - 3840 10.262393 -55.069549 -53.924764 349.084 33218.561 16.235391 - 3864 9.7367167 -55.078288 -53.992142 342.48207 33218.561 16.329112 - 3888 10.171202 -55.134701 -54.000088 329.5847 33218.561 16.415353 - 3912 10.01925 -55.145139 -54.027477 326.65074 33218.561 16.526334 - 3936 10.053638 -55.038151 -53.916653 355.74893 33218.561 16.618524 - 3960 10.044055 -55.058382 -53.937953 349.01834 33218.561 16.712577 - 3984 10.382422 -55.099216 -53.941041 339.28099 33218.561 16.79941 - 4008 9.97927 -55.09284 -53.979637 339.07225 33218.561 16.904198 - 4032 9.6782319 -55.126143 -54.046522 329.0201 33218.561 16.991454 - 4056 9.6593809 -55.123677 -54.046159 329.89833 33218.561 17.097172 - 4080 10.442896 -55.141149 -53.976229 327.9899 33218.561 17.189364 - 4104 9.9571109 -55.08588 -53.975149 341.3746 33218.561 17.294147 - 4128 10.44943 -55.087946 -53.922296 343.09435 33218.561 17.387357 - 4152 10.040581 -55.171939 -54.051897 317.85348 33218.561 17.500905 - 4176 10.089442 -55.128713 -54.00322 330.29121 33218.561 17.588891 - 4200 10.316156 -55.123219 -53.972436 333.59382 33218.561 17.679254 - 4224 10.177245 -55.095671 -53.960384 339.34498 33218.561 17.770569 - 4248 9.7129183 -55.135335 -54.051844 328.25125 33218.561 17.857728 - 4272 10.231838 -55.099554 -53.958177 339.64015 33218.561 17.944226 - 4296 9.9737677 -55.117885 -54.005297 333.07248 33218.561 18.034105 - 4320 10.004955 -55.116155 -54.000088 333.52271 33218.561 18.129644 - 4344 9.5938901 -55.133824 -54.063612 327.84171 33218.561 18.215476 - 4368 9.8954562 -55.131603 -54.02775 329.0813 33218.561 18.306539 - 4392 10.439732 -55.100379 -53.935812 339.81679 33218.561 18.395651 - 4416 9.934513 -55.08449 -53.97628 341.74441 33218.561 18.484506 - 4440 10.025998 -55.136771 -54.018356 327.73718 33218.561 18.593946 - 4464 9.9304451 -55.101817 -53.994061 338.1801 33218.561 18.684011 - 4488 10.344371 -55.085856 -53.931926 342.91721 33218.561 18.782399 - 4512 10.033193 -55.091778 -53.972561 339.85728 33218.561 18.879666 - 4536 9.2361614 -55.169375 -54.139067 316.67597 33218.561 18.983667 - 4560 9.5786289 -55.179976 -54.111465 314.76415 33218.561 19.079009 - 4584 10.071651 -55.107218 -53.98371 336.10364 33218.561 19.163975 - 4608 9.9873098 -55.109348 -53.995249 336.03665 33218.561 19.25635 - 4632 10.143888 -55.119423 -53.987857 333.74978 33218.561 19.346658 - 4656 9.7506264 -55.114772 -54.027075 332.98271 33218.561 19.435425 - 4680 9.9616769 -55.096054 -53.984814 339.20499 33218.561 19.55562 - 4704 10.271313 -55.074522 -53.928742 345.87397 33218.561 19.642652 - 4728 9.9172336 -55.098805 -53.992523 338.06318 33218.561 19.734557 - 4752 9.9556222 -55.12128 -54.010716 332.66408 33218.561 19.83859 - 4776 10.197593 -55.095293 -53.957736 339.50067 33218.561 19.947471 - 4800 10.145085 -55.108467 -53.976768 336.05115 33218.561 20.044183 - 4824 10.205523 -55.147376 -54.008934 325.56559 33218.561 20.144393 - 4848 9.8900281 -55.121598 -54.01835 331.17401 33218.561 20.243197 - 4872 10.03655 -55.100936 -53.981343 337.6777 33218.561 20.336043 - 4896 9.8120635 -55.087507 -53.992957 341.42438 33218.561 20.425498 - 4920 10.615354 -55.093335 -53.909176 342.30776 33218.561 20.519318 - 4944 10.374366 -55.06455 -53.907274 351.10607 33218.561 20.612312 - 4968 10.677474 -55.147807 -53.956718 327.85703 33218.561 20.719371 - 4992 10.558882 -55.145253 -53.967393 327.427 33218.561 20.818726 - 5016 9.4097946 -55.150835 -54.101158 321.62641 33218.561 20.914472 diff --git a/examples/gjf/trajectory.0.dcd b/examples/gjf/trajectory.0.dcd deleted file mode 100644 index 47927e9909cfcfc86ceb2568ba1660efed5834f2..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 439092 zcmeEubx>P-)a?m%rApmsu_RbsfbNyL3nZbgw72dqgu2rf66!*Wph-<^4HzCT{SnRe#fz`5b@<0pHsz1G?Z5d@)KufFZ2{QB$P>mq{S zx$A#^`5*ohne`=5@*nR0#~ao8RtR5v`Eue*J$20V>0uM=51&)NJ9_l!9nAOsEC2d- z=z+f7g6p@N8a8Zt*vR_+t?GB3F@BD`u^)dmY(-ooB;CH&xri%ET zuA4oq_?@ow=`!BWzt1%zO2F@Q-Rz;__4<9T8bx*Zovt>IO!%FyvFSGaPS@{rwtkJ} zcRE|Y#_~IztzTpLozB*;vHVVF>(^L*r?d5IEWZyj{Cgz76E^%cmfr~*{u;~ggbja< z<#)n{zsB-AVZ&cz`Bj7cy8bPX{aZfyx48aq@%7*0+`q+}KjZlucm0{4zwz*Y|NZly z^9uhKzyB?c{#!izx406a6%_y3^>2CX&v^cxuRrtiH;?h3?VVrue!uzo&pD1i`Rng` z`AwmAq{^8C3;fH?J0RM1%|8Q9Ua5aDK z|IJzbnTJ2~@aMez&A0!Vhd=Z1|1Tc?%}M{mz5bJf|KY0t-2XE_|L_O@=mr1q;(zY{ ztq=T}hd=Z1CrXpm(Y^Am!1@=C8=JhlmhR%a#ke$om+@u8W5&4T8^#Y` zoijr9a{~siOAZXaC=2*xhzXqXBRk#p$|e0-?qXx>Dl?56{Er64F4+~BwoYq&xMO{w z-?^fJx+UR(`$BvIr>{>Ae7df6z_=CF(^p>$HokaVGH}(bqv>1RPa2~ZA5ZTX*|<%& zw+Y6ge!Bvve|i-7zar8sq2G8`u^Xug3{n85=5-DollSAt##j;B>3>qcJ`&LpsnJ>fDZBm>Llp!UVy_6lL_&8jO zOD*M)?2;kOKLVMEz@2~yTzjR##UdJvpRB=kYmM&@~kE2TVQBvfvnJiz78t}b+cl!s};M{RtS@=2>)(@ z`Mw2Dy72oV`E`i}m#$mk+0KH`v#nU9v|_8t0!MQzKJ3ZH#urvZTP<)sW5v#4R$PB( zL9tH0)X*-cjVpZU&~Z;{V09(0=1s`?jwhA)+K_%u^`^v{Ze$$jP8~+esq;Z8#gF%< zBQCy_(a?*2UTaQaUd^fTTwf|$LQdU}HK6IwdRlm}Z{6D+V z?j16!e_Bpube_~_mIpQN=tdJ}xYGP8a+)#Pk8-mMsdGC4g{=#zl#_t0>xDF`xddwucTlxd2PM~+VEy?} z+`rrpYnS!I&^jSVa8g0nUX8o0RTwc*3F~t;BBrX)y@nD!SB2nuloB=Ph9ES~; zimy>YdQ^q4$3l@cQw>+O3Om;X<3)f9p@k}hPg0@xLN#8VP@;=G1T{;kvAKj2i&m>) z<>&7AP~kxN5EQMa!u*#iOzN-2fnz!}?HL2@LmfsO*J5rj9hxU;vFU&gmlZlRiq_#% z10Cj;(jl?54(9^3i1XFLRU3_%3R)cY(V_8kEo?P)XfacV_K{jVpQA;sfm$q|sfFLK z=QPn_$zd%@6>2f8l@3z=9iQ&$kbF~z{RKLd=o^EeTrG~4FvGFjgarposI}XSEsxDO z^3#L^uT3ztF`?X66TVh4A^cq?R8vi;KGTf1rOjx2)`VkS&4^l(iD&0BK_ktm`6v@b z@0c*Aml*~Z6NC!)2%)O$;_%cw|Gp+IFPP%7JNt4Ks_` z(QByooK_hoE*3{vq9x-$6u4|c-h>JaxpfNBS2qDg4;8GlI@xV z?t=u3kC31QpPNs$1(eS#q$xoH+-?fE(b+*MLLm)XQb?uS7Sh@1-|R09?ItWaV=MS!OR1U$7}H%1q_&wOZuA(ZO|`4xdkG z(e{BBg%$YcqqTUmUk9(TI?R}%#oj?$M4r~-r(O%y2_0fP#UQL=48D5n;9}I`VJbgY zn}y!dCXDN3hIXeJ>lT`Dkk8!K875pYW}?keGae^o;qnPSLoZDb4w+DIxCxWyn31*A zghp}vvzeJZPbTDEG$H%32@9v05MwgIZ?g&G`MjO3YR1*=CKP-#!DW&e&)S-?rg9d} z$;=!}%xF>Bj8wG=8#N}pt6;;vB{mdpx1o7k8>*DEq1*>EYz4n4mf8g9c}y$v@UIS6lJ zgTBy)obfg^`Iv(x={776%99&9|++B?19+AyQa`IfQd)pEw^ zD}MykKD8#`_4(QXVV(m5;&+ZUmP-f=+&k;@iT97+rN3+RDLt()<;2s0D+A-d8v{2M z>ze+odX$`KXH~Lm3ANN+whG@yZKpt7k+G`m$2J-nVs&5P;DxZgmdoDylt z?L=C1Gm&$iNJXyb>GkY1YHv)Y1G;1yo^GJ^u8EYSHBkBaNfdc1nfhJR(|UOlZ7wcS z&>cP9SeHzZIzmbBYBRsETwdCS|O6pnq=y|IGJ*T4HSG? zibFqSc-}{bB3r%SS4#^03ON?+_r@NH96!IxaBiFo@88H!r7Qalo67OIryR@r%iujm z3Xd6HxLrYppsF(1S9!s8ycA_i%3$>OM&qk8ge>wzpIb7_GDzWCSBk@sggRwA}Aeyhd!F0_~dy`M1#93*1!C_NlyL>zv`IFg_B@-Smb zlOEJvMCw`*9W)|JToSRGzdp*iFp-~On9jJ<*MNm<40yIpM5loU^y1&wzm^D9pam|= zEht&aigPovQ6t!jF}tl;UEhLXdACq!niYYSt;j#cSg@xB1DjY;ow20xwiRWZtVmsK z#hxe&&iY!hILv~h@fJ+DVSyk2zc>8e3qP$GcisXF%frYE^WwfcOH&se^&^^XhTSgR+Uke9` z!4ArD7LdZ;@GbAvDCMU{SQ{1IWQV}1w-VWBwWyk=#T1Jc5sWibjkVY|Fb1t_n9-zx z2}X?>@`6k(Ich@Hsb)0bIB*&^)Gn}LK^+_RF6S7K%V*zHN_ZzD*SY>QQ^)!7rZ>Hf zlv0hF1vFw#0X^IzU~E7k>5~N1>mWgtnd5u~HTI2DLH&*M%;gYt@KR&+869Gd=org$ z9M052J6ns`k~%D(WyaL`CS2WQf-J^_E8-4NoNlQWm%zrPz=+zQD@^DaH#;QAg`{B)JC05=J zL1o5~_8w}8ob&4SkKvr8L%E(h%x3JBR8@yl={ls|HsL*wq46LyigTQw*xif^pG+t{ z!HyanV@t2%I2mNaF2*&Ub8Kkz)Qvi~_oU4AGTNQwLt|$7(&|o4=mq27LG2}&A{S83 zPy}=@{<;oCfSR^f|>8mhKxBwN4J)pX4BE zr457L%4qfyciPykDQ#`slsZ3hBUu?A8g7+fd0k$w0Y#7zEWyC@PIx1A;u=r|d6y8p zAFsr)bTx)IQ(^D{HT*e$uRj}&p3gYvkJqAE865_3{x8>>=V!19yRMo*3KLAvP3Uhl z;REB--4An+=4XTAnhom295lPfzWik(-SRY$=4%Qa_fMk0N_uKh#z5{)9D8?oVLr#= z`PJp9+FFY0XQimnm%Z4>G`PMu97A$7_&QjFJ)<;m_7u@=j~-9Y=ppN>hxomMn&WJR+`D_Y8}comq9xZ#4rHbqcWlt~mXCkl$#k`jgI89{NeOcH&+sHfOr zDWpkGpz^y!GOLm({;m{0O}*gJObSS)xYtXD_=9phB>ubLGbs#+oPxV~Ms;L9zpgEv~y?w+6+-$PLJ_$ep` z$R&z1vjxTe6hX18auPMXmq^ZgQz&q3DoyKUpo=f`w7I+tBWKAmH(CZ8&sF?68Agp} zKEx{mpEER=+L-f1)d)oY2*=GG5pYY@BQ-$861@S_jd}z-889#?8PnHVF^OyMvXipm zQXw1F`ekEG2P-l~K`|&*P@LmAn*B{s7&-}x>URW1dELgqPo zda3k=?Vb!-52bK=zr!Mli-4JVmc^gL z;jvnSTAWwAAJt%POBh-R(d#yN=#J{`1fi1jNyQ2j~mQ_$ZYb_|AY?M-k{vLFEvy@tN zbEirHo-{F3N_DsfscvxmYP3d0u3xPCxaP65-sz`Aoi-uZd{~W2AC*Xdri9Kr6s1zM z8233ECpcF`*3)4!*U75SIvnEqvjSuE<;zUi!1-&x#0<9;X54#YL(%zm7zf)?cc%^2 zAKEY>g6qkZKJ;OQCymT$N@dn~)1;~%lyXB(Z9)oZ#=b(DKdg{!oGT9W6wq*<1VU34 zTs=cjuqFgyJf7wWYLp+X#@1mvv|Oact@~OuPt;*;dmZl9)nQaEGbYHhuxxrJsx!t9 z|6qo2g)#nZ8>aI(#&@wp%(ub+tqu7FHmq`Ur&0BNsmX&T^w+_rw4_i*&j&Rm=VB5Z zt}KB$$wA(nQ$JR5P>oGLX(PvCLwOZmomPUbD`D%UMhQtMrcKtN%v~KKIiC*C(qb0J z>zkEhkmb)jKtD6iyJlfndoxT$*zp3K$k<2tpK6CPx#P`;5GQs!GyGgTP%NQH_j z6=H{IQP!E~$c=OQel6a%)1iZJ40E9-Y;w=Sz1Jq}m-0HbG-JSh6Gn3_lmC_TC+GFc zoJ;48wPQh`9pN7v(qBRT^mw%|Y2Ub!S9^cjztfvaxp7|K>V$Dx2~Ho9pgz~q-I@uw z_gw|g`AQ`9<9T_k!m9ad%$&^iXOI>Zm{*y>S6i+J144AD)JKP}%%2=AYewH!nb>sC zgeqL~EjVIA7U!#4)wvGZU_;AV%v1O?{^9Q%>*Z8=tS?E<`_Y>VGCDp|PPx70l$apF zh&DwaOXAvI?SxBlMbLT^*V%a?cziGzUoWXpwyGKd^O(EZq(oj79e#2?eKw2d<$N@5 z9pJijlolt~WMUkTq4Taxp5kVv(gNpH>M%)9rL{8L8X`sCI^HO&mm-tvjY^-q5G^qFo)V4`jU#a05sv0x zHF&i?0uck4V@+dB%yIGg+ay>^8sHowq9$YCCUvbCFvNnC0t*uAGhY2@!CQl%n7Tqx zTrvrYv;KnO`X)g!ier*yTmrS*BvS0qM4InsAblSLedHSJ$8ISC;=FL`iWEN=b1l<@ zIqRu%eB)T$YP|-z91H!F8pw?rG&rHb>v5b%n}~?K#u$E}i2k`EauY=KZkCOk9#+h$ zlMR1!gLf<#E=UxwKL`prkE3avpy<9*P(0ruD4H!#qAiz`Y16h;a&MPH3pOND zkTchcDlb$Ik>mCmFMLRm!}XgCj$k=9; z&U`zMNf;Y}fIK}iq6|3nUc|v@JuD^>ZAiq8^;XPlm5nfWD`p}a3olu4ylpnRa*lX0 zSy22u!E2N*C@wq_6z_QrzdT5xr!5RLym>NR*)P%u_e8o;-#`lsvc4XEW~Me93O zsE1n6lrd0zCo7IK?s&98P{b_YaXb|iR~Y{k%j5mTxphXqNVd2X8t9Qs*+)eRu9iy6 zqeLn_P>MO*Wmv>mV|G7ptT--1g{eMJ9M|C3t%az~`&wBd9M1=9@HSF|9dD8l+k*GA zj~?fEZZbKyFYLp)_1i6k@Z5Avfvqcr;CW08>a{YV zq?-*m=0iQtNpNYq8Yi#oaPXT6Kl<2k(M3+FOPMb}7J{cjWOrS7FGbXk;;_-dMs8*EKS_9Oi@(ZfXR-(Ly|H#*Hy{)Qk0`!9yfiwLcg` zuWB(=W5Tq{oO_L~w7YU4xx8T>akUnSW6aF!b6uGurwLCSRFwI|qD6Js!|(4kI0ue! zKYBRd39UWVn0!HtO4m#{Q`U|IVFvOQ`x0K*pwi0^I zeTAcWe&*RR)n86yo;cx9t`bAmYf-v{2{kx=N9B0123SamZIo!wIr9#4dOarQARx?@ z7R3Ift`k&f8>&TzluW!}?yF4`DLu<`(1LMFjF9UvI@N^qQa1D`*@#ZH65#wqiNGT~ zZ;ee*)wkj4Vkt?SB?!H$f=gd5c3sIt+gEapvq1>Z^Wn6U%bbILcFcv#bp{P&Hh zjrfydoz-Z;CH(Z1~W&Astmq@Ogm>x9Y|~w=4@e$GLvXa;5y!4l<2ZV_j$FSDnpx z$uvUhCAo9;m_YaR6cuMnJSrbF#btdFeZ+Hg*N`o+<13m;}53kFrs%CUxEO*`6i=t2R{JVr=*IUM^i%sas zwQnb7BidY1f}TTEaChS0+dC88m)o$Sg*W9^74W#G3O#>BBP>1>uOj)J#`;mkC#*5> zd2iU0apmMp9C(|9$}1T+*K<&UZwS(OeLaIsI6TjW;!WMiBf>#4=A4LeU*%IKL@8}J z9@Bs-%N;a)w-S~b96uYG5LCyG_$M;@YpQ^YrPUac5RDHmCM5BG(*=1_r633CE~_w} z*U_vqA#F2r*1f!GMK1vzSU;%7^Ru~rCW4v!IPKv^LiYly;;X{;8Zmf(oN-)t){VM& zQQSxYJFIFvHEZF-T>OB>{C<@uZC)kdD?g_m^ZskwG1i*Tm~T@Ps<@H0$wg{BzQ+8E znYoQ+{P)iHAn}-k4%H6Dq`^8|FVA`#YfiT-x>IIT)?*@7=)mzI*~bLeNjALqkWp`c z2`U7uG5fL(o;OWsKaRQjK_2wpA>dj|HST}bVoQJ-b*I^J@n|E8$rtebg9;6%>9D%E z8J8;C;1uOW?k-N)^Enu2Pw7}|&P4P1HVm)oL&M%M2NwWzE(Pre#%Rz}|UNpG8 z6DEOqK>m9bWlh+;#D-bJlIVUvDXO&4U|~DPRm?eFm@X(JUlVD6TQBq-!1Zyk9tT{l zNZBVS!p`X_aIGimc8|dIED@8RS&+z>YTt<@YSPpjuTE$Xvx;lf##W5Y78DjSg(~&t zdYgIP2A&3tQ)eTqi=g;k$w0B`-Vg_AaCZ@NB(iJ-_Z1Z9$0gJE<6cR;14q6mDx1=+z!i$R3BozDdNpZWaWLWsV?IB(Jw# zxOXWWPgaXK!kF-)Mo`>+ucx~r^W=>*cr;CfUSfqjR!|I=rqcI4jE$M&F7Rhe$DHqY z{(GOcOQtW7!@%|U66SD(4;H-NEhwVzi=-C4kaj2>$38F)9b-kE5J90kqNias<>)w5 zgRDqBG&a`$8w-k4PRVrUvJ4c@n06NP$_*@7%v{E)+KE)^xfJ{V(!kn-@!BE_z*tpX zN>9-|Z?#)%P{WvnIgF3azY!G6w&9BU#pF#KR1q&M^M^96-@mYxR9m0}U&-sN-j_{P8Y zR98VEP7=vC#2e<1;V}0RF@1s+O|A-x6GaX5&cQhGp$6ABifF)i{E@$)7*RQ%Qe|>< zn;n6xLqxd5G7dEhilkA=^u|?&vk4mPZZ6_(t_4@O3JOmcsJ^olA*aJJll>{h7h0iv zA}F*iQfTHiITkL}z?d)MyVZi$%-cydX85y9G}C97p>k+WOfGIebpH-qGXbCo5JmkF~g?ft;SnaD_Cux>}EL?`&NE$b8^> z109fhV{t|}igOKCvJ2}Te+dfvz+`GxC`H3W4U$i=CbOS?FU=*2!Ab*7<61^}K!d_r zdc;3qZfG#i&j&qq@|9wfgx7Zh$ANOJo9uPq(c45iv{!})-8GoRf7gjhR&37{6y^IF z=oHsMpIJMSeiso?J{z~^alGnmpwqG5P@fD(!v?(WT#p_ZEK$IaLYov`%oi-gD!U$a zCt5KyNTOKuIGHv^d0|W**O$liD4$_L^mswh@)&c6UFE1aUjv0R^MB`Vq0bOO@hwVE zzVEzn>G?t=*A&rWo)yj?9jG}kiFPlQA^VaBk3B_H$+Mt11jVC^i8Qc<3|)t7@I$S~ zj9wO;Ud?s!W03}~^@6`O91%72khizsS|veIN@1XSC48_$9f36$li+aT`fRPBsPH<0 z6wf>naaDtLkJ-nRmW|#=ne!YFPf<5yc*JpLcx@3im~*>RPEd5-&-=5M3?IH|(4FhQ zp6M2BE5B5)#B&ov!$!pVXnHztwfeWX}>mdC^AT06&za*G7TD=~qVAM!@SKn*JL{-1x@ zio<;b#bQP6qqTWwIA@Dp@KPKbc%JFlCh)2%ZXw2*NU-dJlA3d4gq1buj)yNTn^FsyW z;i>!Ew5~QaaQ36>K|{+f2$-Lpi6qo9 zP-ou5jsT9c3uMquWbdL?j)N)Qu)dWds*MbJd~d>R&QpD**t}SVz$r4EIK**Z!5kCo zBXKvScx02I`g|E`ob@ag(1}v6~bR z&&wdaD1+&k9OwD_-dp7edJv9q-UD-XuqUxq1d_wp)99l?_Bi%6#%WO1s=YatXuo(_+IyLtQ)IAAU|hA z`3O|)7J-<${G7CfSkqO56MP11TnNW1_Dp8*{*SrHnh$Fh3;3KJKgu!lnFw`H_BX!J zBdnjEIb0DDr45jc(Btk5JsQUH{%5}Y8G9b@))2Ay6X*NmBANwo9{HLCmzS(tGsl0j zI&0P8dd#23-o-=_o5%8d`!j!Xm7iaef7fU|+-%HU7(_hTF2doiN9PNyF?kr^y5EAa z35?bF9JkoXJp3Eh1qNF&coOFej#*}BD^9?Q2ahc1r{dhT-h!3GvZ3eqFWJG`_DKtB z-?iZGCkqA}Ecja7ib9U18_X7r^R(c>1PksLvKGCOwP}tR1DtS>e%# zaS-!4XPMvWIm3$0vl>xkHFrAU;!jBhQhHn6ovIG;AZafjO3rISWk-5a`EhbeW*nW) ze#h1|Wt3K#Ie;Htw6>L;Dn>V^8v|wJpC_Y$u1zR-yp*L5{&~xalM@y#b<_Ke>oKfo>1d<8Lq`< zg<|F%CGI>9L19xBW+_#eX;5KB0rSbCMp8a2Jx6LpBa06TQ3wnv8zd@V1~VtQ?^d8X@NSs#N< zo0(79t%cO2MZ-xtjI5x;iCtQ(tgeN#zZNt>i!RLbPw%Y*`skp4AICn+d3u|O1@|Zh&&h@uT1@3%7muVO@JF~AyZB0I){0&VrD#*n~=}7R_-R&u1~W+E7ydl zmCX3OnmHSP8}>)r(6gEiy1q8{gykSEn>matcC;U8L)-o~Tpw#gs<#~{zvSReGp;MI zu@1k~2In9fiul-YIFM`5LpC_9HhA4)52MzGIj3@PvXKp6OERCfmbLoBcBIN}T*Krb zurLSNk8-f@9KZiW4#x`iHny|Fy3Lb57IUS71MJ;pA8@GwUUaaWj6TH3sn{uRQdIG! zI>)@IVMBj zRbQIF(1%`R%BUXmCqE~6({elWSoOSU|7Tx{8_nEadskZCPDbwA+1s#GPG58m>dySd z>z)$y-sFVCkpjwcy}OkCio-o5=zPvWBhNc%%oz4Ke3D?)6bZ(g1YG_sAdU64ydDDc zvI3?bl)%V*R@W!&F_sA^w#Nyh>Nseunf;E99hBxQLG!2rYF$Nw*@K;!1LpTUmLTD# zfMGui>DUwp-DoVpzL`A%%q_fI#-7E|N-VjiLX)>4=)-5FyIqOrBh(0Ouf`}Z6`nOy z!#-Apvw9WudsNuXe#YR%O4PllL~3$Bls%wAdK>0#OREr<6N2LfN{lP1MArQf6dT0n z=U6a^HJnR(l;}`IjXCZ3=L`Alo#wOoF$A5Lsc&U$jbUCgJrkw)`!`QaSazBHFJa7iCh$30 zZGs}hgrYUfILkV#W-ogzx|wj2pSNP72>}n7Gp)&fqVN232TV9JG7~qL*FEIIoN`4o zdQW1ljnDUf*0{Fla!_=R9bJy(pvD9nx-POIG|z@Uxi+-EYeV;aIhfzfj%mwtFl|5k zgAdv9I>UyIeD4~cxg9(BTwbzagxUsavK`K~+2_c7o>ppu#n*;nzIH6?WP{HG_Mi0R zGpDm*c2PST@VRZpuidZPU^FrhdY`$(mUisxvBsD-;iWNlk0j&Gmz!<&)N~JQv@tp` zZ;2+ba@kdZXOcWKT5PFkEZt&rz^%~Y#@w)*>Fu`d2=ot5H&zZv4(#78FL2bD2xEWW zJAv`a8i6B1o*JWS>`uQ@w~Mj+>7Ie9&9?<+M7jo6tk%cqbhfoocXW=i%&sMY&+c_P zacXx#o34%D8~cS8Zk-~W)YcuWTNWU$|%0L-P=6YdB4R0J> zBS+s!QnX|Ic$M`)|2LjUjF#e6QyHGUlVR&1DY{0=klUF3izB57@9c#(wb^GPN-_SW z4CCiAMr|v@nq-Or4a7w|tPXi4?!!^iX5`hl8HTXDQgBe`k=^k(& z%pMIoT+m=K%gm)SYOJF^2xdwXX6mGTFBc!*8jYC9SV84yDsR*CRB34Zi z5p!FQEmK8&J;5GDFaDfw_9J>T-aFjM00m>nr}y<(b5)P=Jz2{eZNPy_?0aPY&_X{E z?U{SHa3=|E-Wag2Bl9=!^r*5t3E|9{GzV;TGm3tjN2_JuJl-BhI!!%e>6)6;|{Z!#Iw(Kc$ToSJeFd39fH9 zSn+VR$P8|3(f9WaKI%S zjV@WSaI6(^Tnqm5xge{Sd(w_}a_Y6nkG>~KN%-PLFKhVFwfYiNyi-62ck`={1Px{t z#e_!!G|CX9aIF4tk$F*>8nKgE&ktctq-DR}BQ2^B`vzZY;cMeKcZK;;j!DLTW+b!z zaiKkX2-%Z1vmW<79OloDx@kvg3-=W)vZJf(TMS_RWny1fTI=Uc8_Rpspx2z&)KXgf zMou~1zSF54tdETPNw?XTFHI_-{6kKtVW` z!`;P)F7ezPpCl)1o;O`)%v(Rqm)t%Tke)sMGRBqeYYXY|O75fiAfR>!_7jAKV%S$D zj+RrRVGAX~t|@UbOot;cbr3?dSoedya`8HJe!^d~=i-+yZh(&&or{{ee}v~M+l&uS zIX;f&-U){d>v}UEz1fDOnXKQjZ*W0eHa(n^EpdS>Y5%j_K`33-YBCJ zPa4oPiJU?%2r!H(pzbdP%x3K0LsdwNc~7E+1xc09pcq!yet$suUMN1 z)uBl>9oBI!&b-an8^*dNO}NOKku&G4PLXCbUuH(DLuL$iZ^wUZrB zy0Xtc%7@$!%IVuSe>$;?eXy&&skPmmicI7_s?$ygU&j3yj9H=<^Y|t^=s}hey_>L> zIFNP539L!nRbh%s4gK+GJgcPxF(xQHqeF^b3x6Z`5N&1sB;SmVBTcwj-h|h;&4`(A zLO;sEraC$3!J6{0%pA1c%l?p1_JoW#(CPADBR0Q6x-MX@mZQg{>}6hzb=L5 z>`A7wvQ#p&KYsRRPxOkDq2mSi7OdlV-araJ^2VDN9JlvGV0;Y?pDzu2fi>8l#vJ&5 z?hlk0Q1P{h&Ri3FpD|!2^GV$bve7Mt{ny=@uUu)x)d^O}dN6kuD=2z)6BI+23JU+) z5=HM8f})9?_5INXqRdn}(;%7JbDn!RJC$%fnf4gHpdT;AxWn9g87IY&P#K(S$l;e6 zfzfj~M;z1O@@5V8E{VXH^~?`^6=Ap~q7Do=7sdQ)on+*2oxU!TJ>#hyD~EHxV1Fy# zdfmo~hPTn&!Ja|(>xC5viiNBzTp7dTVt#wZoCG@hYkoXas8eJ-ZQZM@(?sZ=>e0ZJ zb5W`R!|!v9ceY}>*@{YQt#Ie~U%xT0*9<|CJ&<{2=D-gXlPJpaTBY;4-Q1W$*GeUm zY^O+j&WfZ}BvXDHJ*9n4;vU_MCJ`G3hv#e%mf0rMv-Y51Idr+^UupM)!i5F@J5ji z;mFtX9%divLH0N;%wU~C7lHS+4d|*cp!5j#$von9;{1F2frudH=}U5+E4GJyDt$Ot z^4|Gc$XsVz)@-`)e&IcByvAOlg@U5-EkRLZvtzU)ol8tig5_i}FF8f~Ej{kXm=zkz!kD{y_|8478p5*eeo z_v$=*E}ybzBaQ3+lUnTI`l0R@_NK+@@Tf=@N)#}jk72*XB(Bd(vhQ4BMsy)-$VU+-jN37j|vZr;tgYZ-eR z`wG}}f%`d`2l>)ciLIs7*j7!6Qo%|DNOXAKh2!91EhhZ(#ZA^>_+A~RjbXoFu`EQk zGGkhQGj@D2BXAbyvQ>8Y9nHbP{W;ipg7c{VTe#|MsO08FwOaU4{7z3QXyQR5GyJH{ zZaIzGUPu)ybHA#O6Rw8~2+#@e<2o|cQ;F4#F%o*JF?cKUGdxEIhY~-Iu?Hhc3(E>E z=6&OujB{$!mt3FCV|}%$89h_E&RN2Igr6DZ7H~eDY(v!m&RdaOr_|%Tm10L+T^lq{ z{b}M@A8I&NPHQ%JQ;n-$q-xi^80T9%Sg-J%kxJ)KaN$Fuah zfVp|xTf+0zC0GTIiJZSUcloH8gSr|Dr|)XS^kS}OmlmV#TD-o+K75{^)}>+)9?SlP z;U-usm|^|IHKLapho3Vpi{L)AYrH;rHi(RYYBN4N!~BVDxcPHtmC-jrpHLD z9&}GkQ@g*S@#lIV|Q@f zu!wu+%SPbmBMsWJcKqY12n%z%%acSr9-WMhXSw%@^XG>S+34c1z|_@>rPUcPKjNIq zvG~Cw_Q+M2D31QpT{tc_f5|a%QzDgRjm>&6nJS!2qmXp|+=F-n6)7vlf?jgeZNeOW zJ1HV6%8{2Qg^}}n{ZRH*_KZN@!Emg9wh+b?u5(yh^a*A^_Z&SYT{j?qqX82yh}h|! z%|2c3YvTM>(uwD4DElkz*=WsqtJwn9yJoZYbWl*d<-Adzb-;IAM|Mm$(BSw)s@FP^ zKD|mNduKg0$mSYu1NQ{f<9@d4-dNU4hD4heK3CGf?#BK>Gy4q&u$ERBj*sPd&V1N2 zkjMJaDiNjjvflmF02O18+a;~&)RF6m%2upTWR29uz57zm@lOTCj+267I%}Y>PVriC zzE5i=Cmt?y{j@LwP9aCmK?ICtaGG?V;|Rk zA1-S!+!}$vXbogh5$Lj;`_7odPviP+MMDuE=NOQ!Y_*{5 zR_^KNxk1GVk%GB*VRLsGYhm6f zJyQl>55^mBWVpLrhN!XOSmdHX5bxvp>-e)6ShvjUslmH5to2Xjo(`U$!=Jd0OyO~{ z4$!zebMKr(!v`jRC`ddf)Rg1M4?M|>Z!Rbvp# zJW!<=R#ULFc^`IIo{vTgx;ThNnP2`(t&#fDk*WJ9($xe zWgwL~(KoML$*;VCipx=;KBe*5+za_dNHt8*N+<`%vw4 z0pi3^oSecv`3=o*-Dk(KvhL)PDWD(waY}n~F5a4nu)#Ul5hkUlMhBf*)EC?5N2AJm zj$LzeptX5WmCp`}e6ED^yJ$F4GvSh!gYv~>^pmxNj6O>EFV~`RYtENvYzPTzOlc|s zb=ZG&vXl-9?C(>&3D#w5%qGk8EH=!vNu?X+{NtwdThdt3pR8Kai_@QPRPH=TxV4tKl{agcH{aw)`t!r{z0A# z)QCHy#TBmWuB^zxy(BqZdGV93$FdKOYny!*6B;o0)-T7KdQLB(#kZ7bbu${X&v38x zt{l9W*pRx;WeumJ8e=!>u#fBcPbGPrBm602qrg4QTvsxm`ieD!Z3nnEoYH`Ly~(Gq zFO_(~IeG%ul26Lpu=sK#GWHcP^okOfhiOr>r3p*-Ft1)wMrEuHDi#~cHMtfeyK)|X zk%PYRo^;T;kb4P3u(zlVo12?3q@NAdp46ks#~DYp4nf`q{w#~Zj`Snpz;es;Jud57oVeb zn{x1Vl$5#-{Z35^g3+NF_qx2!#CFyS${PJ?ty}_$TL>mH|ND6q*T{Cxo4@>G2?B%# zO0053qtScz7nir=9ryZ0bt$A)KL=!hfEG$6KDx6;6Pt;NTx)M>A*WMK1aul7f{)eNH@7wu$?i4`jr62}asi3V zHH<96_Zbtu>0^U?XICnWaDv|tHTvnaC^E!^vrlvQGiJQ#Qau5_H9`<`Rg0AFnON~4 z2iMknQ{=}&iX5WE?Fl-ZY-&PbSw8QjJ*a9g)&+Vg(Xq7-)vf&ZhH&3H`!rh)WxnGY z_eYM^Vfzsi7H_a2rJN6Koy(d-Llu5LV?QSQY6p+7qhpMmy7Ffo6l<@NXgAmNbQy=A??GxGhCk2$Yk>nSIA?d45D491XGXz_@7hlq3=W*w7~>Y0FvUAQl_ zvTNPFwQruR2|e8cYULZ!BmcA@t*y8{N;eZ+1(dK8A; z$*^02ZG_!}&F*Aicd}W>MquCTyuXjnm5o(h;=Mi;Wd`#6)LK!9?@Oz}9?~;HfdU9cPoCQ?&!rGm^8r-2`EV|poT2V!xgFDW3atn6f$=UiB6~)|cbplES#x}0->&zkr|u8Yg#|@R2pw%s_>wYtXoT3}&`rjhaYp1Z%y8)Je4|p+?a^(b#>T`2#oUtKF>7 z-g73)zOnRNnWZC5Yu(!&7>Eo}#g~EKE4(v(R+i@YDy1Z%$(xapg#`FC; z+|i7&{Q3v0E3`M?@0Hm}8oVtZ4eK-$zWGw0p;l-&k28weR}EV}F`%y0>rt2CzKxiY z+AOC=_@Ec-NYCfY)@n@e=mM_ine^10R$;-EXebL2BbsAJT0QDO1B~+iCN()nqwui} zIfzB9A6eu7vo~J0UR9%rEgH)QnUK&s16$9#(4c6dB(SCrkJe*jwh@us7m1!OoX?Jz zhFw(H%lEz395al3&X!lG&pnnT<43D-h3nHjJP9*Lk_%|apLc*!e)Lx3_6}xF5U={T zDf1AB0d+r4ozp$$q)p^L+Q+Z|PbU86dY&@dB>#3)L0wyq3f#YWhskH~eNTOoAPXzf zQ$`JtC-pIJSK2Xy-rS!P5(PU{$QclYrZFZ|<30@zRcNcz-<{u3gZkcu88KuxxG?~SZzPZQD#@MMfA=5ttZ`<;9OG*~=ST!oN zjl#ffCZylVz)9j)FO!p{O=IS6G~oLlVZ!}~nXuQVetAoRG+scg>b@TLD<@%_yB$KE zW^3x8-R5baHS*ujoAKeh9fxmoJ#+n6u(3Bd7L7rDO*s71j#AW7hB?ggVW}FosE-Pz zpDC5+Si6=AZD_+}$@FHw)sj7Dq8a%<#QWAOw5unx_Zj7f$o0`E*Vzoq@Jw{!zAk&& zEE6hG=j%nx_o*4bcy6RLV;^-RMU;i8zuFpucAw4g_+W?sH-)zLextn1Bj?9HyZdnV zAgk%yHY>E&=kfAxvj!Ww>#?|-8C_;m&%2tvp^CXFF6zYib9G-sP1FSHj*2O?_vabK z`+}M{EpzBbCE@BtJG^-=we6iK6R&8Hqt|0Lf8OaYs88?3^L&s=`cZ>6!-tx!2jtes zMGc|;*S$%y48EYj!wGuGCvslrnC;e?p0<@n(M9le=Dl!*=R>hFnaF#=^}lkTZ0@f@ z#|7m1CYn(7nH>$5@cb;kS8fGp(6mVmCRR0b9r62e{nv{$OZ8J~)NB)jo!3nWV&54{ z%rx9-mLoUR=+RY=)Cl^s7u)gYlS132BXRd##AgRf8jyL@f1W#=i2=LJ}@n$9`tW?gOBsh?%JoHZ(V>D;I0j^iLaaaot}LoIkUc#j8MO@WqVImWpvDTm3VkuqE-)!&BymzG+8( z6bLTSqoAeT`8dlC;XeGFAakl3W&h?R$=I`3?DRFZVOGvtdJGyJ;JICzp3r&BZ!DH1 zlP@I8wC-jZyWJ?K0?iWUXO?qo$y+Q<5RWrS(t}^G9`{D4HfFj1-Y6aWo8;o*1R4ID zxjysEGB-6@UN=sb((TPMyh5VPPfnE5#AizMN|Y%&ql9PCtN2rcu}#(Z+pfY2-VN0n zsj<7W2JJrj;-!`T)1~yIHX$Z)P=jG}e9>H^#>|R-SaV5(I)NIzU#mvfIn>&(Q{z4V zp0-|t`!9U4gMaQpKAeCmRt0J3iPb<~LxcPBWqxWR4k50^K-06+ZJX@I=1|b%m zcA2=)9X%TS(nE2Tf3`CpCqmC0Ha+^CipESwG&U?`KEW70Mvv8FS#kPuePU2tsC)bo zg$dL3SkaKW$PUypwxLILtsar-(Rf6RyWu%<*0cC^J8^yU{}1OxBO^N+VFUGO+KU`U zMl>QD^6o9D$16TVG}q!c-sg)4n{k9(PwzAn-s!lnXPNPm=k!1yu5H#s+0=HoZ%STy zvKga>F^@6BjPZS#3oz8otVU)_oHe8B0De5b)|0YHm}fF!>~bUI0)3ZD=@02f9b^$R z4C9QL$b0Il-N-Y7y7r00!<;7SK9Ya~JkRIa(QUgOXTN43zcFjAX_+ux&BQ(8EV>$Y z3>0E5ywe}AU=9z@k}KTr7uIKx^UOrq51Cj@op8_2c9?ihwyl?mbG)}75;rPGtmbZ- z9d#m@b8*#l?2W$T0n(oN$by)Uxoc@-ee z`JOUrtXghG(Hr)K+N?svd3}AQ^gusZ;qVdVfjScK-b)^bYouXgjSO2HD4*$1Y$G1h z;-9*5VzF9kTkA=?OiyVYtHib%?1!Tic-+z@ElVh2eBqM40SfpiawP9Qv6j90Qsz>w z^lGbs@AZ7y_ECxCA}(U^3aq-JgwGf17Y+HME=w$TTE6T#qd=WVC5jUR|4~SEJf#=0DeLxu zW*t_rZ(d1$qd~QB;=d6X*iVOwo5G;lMNQVoP!u~Cj)!qNDA%%{KORa?pbn>qnG~22 zj$NB{c(_If%T@9L8R5)wVOHGRFg)uYhKKugIJ-O)S?_glvG=)4&a@wUg4BY{WKcz* z?SnX;_v}mftN%87``JTmxNX4C9n4lFelWj@0n1byun6oy%TYH)uD%v|j^#%U7&eoc zKV=O#IL!dfWdkl=HDF%rIMlCC4mLLyDdi2gLT}o(%FLZu5{HUr1KJTw&@y*sOSS?2 zH8Fkzk*4L(`%voNy{9#CTy zWW&34?A^y%@rKz9UT!v|CDZdt?&t3-=@|FUie-nacox8{#j50ft6A}PW;)6~p}z4V zySIZb_*j}@su(otuh72fZuYdl5`WhEQh{Y{ML6?Iic>ZhXKqbYHtnz0Vt zyyQR-dF>xr#Jj3Eux~5-%a=}^tn9?MYzOitIM}CWBZeR2=H|qo_sm;jPyb~TKaPL5 z4tAjK3J1<~bfPN%FE!bTXY4K0lui^K$A9~q*>e64OgZu%PpEA?)|0%ur{ax~gktY1~q zX4{17xa=}{sD5pElBDz(F?0X4wYI)x!{f(}j9VQAnW{?=KC=?kfgRB}%fCz|QhVL$cA zub)yc@tmGkPxkRn>J)Hhh!79%v8i$RKAKv^Nz6p~6o*1j;tS3DuF;lA$b5yy1zH_fA_Q&FVdMt*_=ALRmeQ_yjXlgMNBPtf{Ul=fS zumP_9)IE+jpjom3%R3PRsBM7Pj&uy&$_&NFR&37U9++lD!);bfDqzFG_1tq~=pRnw zei~uLf)7@#J#NLSYt&D0@4Xyh!zk`O$0aMCa*vvO+UQT<{_&*lIFcI22KxjqtJ#Jaag)E}xpCUG(o4ClB|F*{GTHjGtou;&umWbYR9KxOcceONBVm zi2HR2_vi`kt+C~qr`q3vwZv*WuXf@|Q)*9+I`H8bb4e!gYw-JKt#e|M&H<7naM;|^ z>K`qc);qY`>9q^nT8?e4A6$F!!P8G~CR(I$pH`{G-dZGjw`KR3BEh}imkHi!7}P2v z@80R#-L|)=-`sS%U|Y52srOLJmJ=FF@2F5qDYgXhHM$3ns1ns`*{H9r`h96 zSyFFo@YGfNEkjggEYn)tu@oFrDXnY#9?ST%H7#p;rw1Q(BwN~)8GqWfCP8{yljPOU zcxgaBf6XV8c%&I+8T~#1XU%eZZi1wE8pZi6LE_ueLpC-=w!co2*k(o? zO=1MGNpcpL<=J7Q^jeuLn-f#yk9U%6qj%;>Gn4djH_C5%HlHjpOS9D}^1ZK77Sv;g z6*DA8MjGW4{i`{?Ch@A|htV~OQ;hS4;-?Q@cl1R)_Aw>;X^X#8`48k`_A zMkKOETyMtT9n2`DWrpH&)@!UAO+}M1@hY=4MzD_^NN&|^!sOy+ayDkf^W)l&Wv%F9 zCiiaUd{v;1v@_Km~lcs+MICuRf-We8)e7J!*=YA&qSX@_ND7G zv5|f2z;W~@FU!Q_0-5B0=!a>>T$W5b=BCr*)-n?(_<64CcHF&5%xnp3%`kf6JhSlp zGO-%sHEmC`US!R9No&V2elK(3EchB(j~4#F^QMz*4Mq3RU)EF#lKt&{CE%2=`1jFB zW^6&+`9t0NJ7xvwa%InL1v<}Rj>pk3Y@wHag(Cuom<4f}dbBU+!|*$nHOUO>#k;b; zm>h>CJTo7VL+`c7iY6zl^j_F-vapp|T;$P85o4vk!BXJ^PHlEzfQh*FY6mv;cOvn= zhqMdzkzHPX;<3YD))iLC{Kh`=X{G|XpB3oCd#wQPoBXBBOFE@M+>tOeHbvmpL;6QX zl9O8;j-%tlaHS$^qtsYtz#4Gbo!Y$>aky88HBkxXAhMq5a@Y#PL!P64^so1|;^Z_Z zjxNeZ^FdDd`I0wU#7vXV)N1ch$)f~~+@zPst5;$*4cRG^UphMXz`3*_)$)TA9pfqkFU);J{$EH2Oc}IwveARiC~^Oc}4$9~h3DUSW96Y{YJR4d~aJ z8vn0+jtKf!F7ocnXPwCRYFcj_#$Beil3JB&W2yVx$Xwq5V)PB1n4aUnibyA75}22* zXV#U6O6Gj`lMOmwnc^ELo2?CH$1`Ti{GdMOsuBlEGjD4fdCnOMw0!M`*goOV4(f|8 zws0Ko9L|iAa9lEl!8MP1BJx95bLr{fUEQck9CQK9Nb|74y^jqymNL`(r4`wCY^cHe z^2MEO9Bt^ph&xV{=WCNQlG!wTwu|Efq(Y8b>aFpWBj?zg82n^_GEjo}9`$s0$<#GU zjOY3(wc8DcCn=e69)`lcI$#;sG3yB%^AUs`V(J>M-B9vpgEt`eeH^@9%xH{?Ls8zh zalALD6|>=1mK8D7gJcywL+p+|nYP*Z#k=b(*YVyj)Q4QA2GuiJO3@o0Fg;oRq3&zg zO|$HXNRgK8wbKv#VN6XwO!=rm+hAXGP9>*aDF!KHc?K$CaD1E|X*c!gQjL8y&zOUw z>DNnT4&q_4>-`nV09_5RbZp5kQ#h`K_ zp64Fq@%daOoq9ZfPOZuV6SJQ=qhJrQ*gP|C%w<+UmKiNlvyfxRM3wc_Ve`3Op1+50 zJdb|zdsn2^A#RvL+wl=`r4VAw)T_MmH_2jCioCyTltauU@ZFXwK01?BPUdWhTwiQ+ zYH+4@IzWBHSA{n1utK|$*m>JwN^RV_WSLw)S*kZr zk>p~j^5{&mcKw9nGAm$7G~U^W zhq#%s;*S}%d7oUqXo3$pfFJG6@XN5HSWG6mj?Y5c6y5PxZ98B;Hsk;yf*kvO)}+wWV(~&Wx>3sZA+OoTa20 z4nEJ1LgYhMXX1N&yV7CiXlznN6z{S`+WBfcpLt zLOp`nD^UJg=r0f0f2}@C-Pb8M9B-_^ig z%=}Bs#*XH!U)Pf-9nXB&7lGm^5-4j%)5m#4Ee9(G%FI+|=RRcqO>hBpXU|oZoZ#KZ z3bf4#!}3?uz;_@&9utN)55h2UHRn1s=l6cdISh;9kbfc$E8a2NeHZ`Sm9;)K20iy! zG4iYx@%wF<&VRd9i5Z9msDCfa-jvVr^{5kP8hk*Z%bcgNBtX)A17!DNmH3tOllV2w=K()0_QCej{#5o%@Wo$5&=Gm+~gADdn8#>w$*N@&T z_8_fSI$=ERB)8#&YdL+7Wi|4qpGF=#g2at85n}1*xHP4)Z2C`g%4gW*<%WLaU2=h1 z_~(1wQ1x;c!cK-WcPt#%65)8eow?9I*^e4HAA=Z9gGO;^#Tw{~&4AmL9rK;|Y$oNHIEdymQSqfsS;z((R(C&S9o-G&L&SxPAr_<1ttfZcfMbD9*0v<3#(t4xG)-#@^rA(78LX zpnQrnW~NF(_B+i!n&r^=REc{??H)5Aa?{DT_S9ffDmB%InZ?4KgsKzBqqNoIBz1$m zCdJ^GgIH~IYQ6t9A*@{zvbUHqjy3q!-{gdNf9UH|dp4im9itsrt#+(YtwaV z2k)9?^c0?bG2|0@Ps9vVY6UY;a?vperEFO&S$Jw?h)GfU?lDe_p&e8wi!y_fLC zb*`bnA8K^YWbRFI=DHYS;9ffh_p+HQ%zESa2YS~&vd=of{Gy*`oS8?jz#(SoPv zcqaTxWZ~o4Oln9nu`Jt;iV?)fjeMU*DztOIkjrbP)SjKE&^}-d;!!9h62s4{-oci9)WmTS;(mmZyV$DoKl1|MI?piMF6o}8nf zW1|^6Ba*Ph$hxBwy&b{KT5&RO^at}k<6e|%+5PY)?MnKkNq9kvl8YO~aezz6h>CV7adu@XuB=(F!ZjdTh1?j}M25ky zFl+37R;UWmBX0JS?N9UMz|c@gngM^$w_<2D>c!X#+TZ+<)?a#~mLnEZUJ*;$l#O!l zJ>)fW%1T@f!SnCTechXmnx!3R8|^L&O6ADX<6)>YFBZ$A({cP(HX^or%BC^-5;u>2 z<7UL0&sp(!3BOKVZ}B;oCu3&o@Qrxe)^AoEzfBDHiLWfCuIlOne*GD-ICPSkw)d%b zJLoBS8}gY$ABvFD^gSK7!gDMA>>oVkK<#`vQ$&YZr(>~hGjZe14isssmg3>LQjD1W z&8@MxGLe|rUe4@!QCDVM`YkP*ha>a@{lyCU>fh0aRM10ecFvV%<`Crb3H@wn^_Yc5*d*v_W2>O4Wr(tB(b*|>_2|^N)h6xUt^ig z&%P?3-?yHMzIkY*f1na6g+g(OXYo64dh{C+U!EHv>$D0SEJNIrSfRZXvGF3zd)`ma zTtL258xaa~QD)YENkO+NV#A1rmtgO-gEW6JUwXf^`y`e=E{}O;qt$+(3Z2J<3(b8oFSArPl18SVHnnuwa%Y(EH`9h5&OB? z5iXgTPW)73fcvv_EbYqYY{k5b0M;+OdsqKsz##UC=amlT+-PK7&L6q_JRHZy#G!&S z9jcRDS7YnQ)MtMrH-a+(co#M*cLsM0FfW=sQol~WrN)XdRPW36M*ZoQD%n`|xQ6)O zaEURD+Wb&@1E~9ZT#7xOvaZ}FFLdEC^B;B_@Q`==Top3~j(CaN5Cz`#)gieKvmH8G zQHr{)+9T^r-Cy}~erp(RM6x!RX~lt3e4fqpn4Ha*=GNZmH=H@jrRf9d^Yn+{A$(80?LokLo@8A#{8qw>r>5h-=JM5AP!~;&9h@}^d@5@sMl7?y|g!}7c z1sw)8;OoQM;0k-k@<%;oH}RHsX(6~BM~u2N_w_CMRQ7txf0@-a=j*WkW-LxDq7KfF z`Iz^;WLixH+!}>qaW4aQF63+nVg^e_F*o5{uADW|4>FOtu9J!R?r>n?bx$#F%9SzB z5KJTnzNaO1&}XSLec&St)#TH9QfKGGybE1AyvK0C9Qm z#>F~*QpPV|!aGx^Ol*AT9?sy}LvF-TTf$qoq*Xy3^u)yrY$vxf)Pcs-$-Z`1z`bq= z%J7`I&iZU)ayH7ItReT;=1I$DI&5xhz?dRdto+JZ83WZ)_hG&iTq9K@vyjq{vRJ%Q%*ttnb{;&c;1E*k1t0L|JqvOm76R6KSHqe zt^rX|%pKtRA9~PR{+Y@3Nv!Hm73!A)U_<-hOWE1f&5(QL3DcW0U~>J|BG59=D9@NV;NE9Zp(yLB?!7S#cwPl7+Fnjo^MtSB*?7AxR4GWuL zy+nPYRiVwR6fY^mRB#LD^8^!@c*Hy))*~TZlcZa=H&$+pLa#PvJRWPuJ?bTAO-YbV zZYu0)!o0kx%q}WNUpaf=Z%q?rQ6^_vj?&{q6#LUJ%o_4y{@ROulFeBJ{`BA{ji&D4 z5dXad^ULTRxn}f1+2_p5TWG@SqjoH&kJCl%N3@EXiivv6Xl_QKiOfTssnCw8W0dM` z>1FM%M{a}($7+%1XB~As)-3C(BYV-282LT=SEKEiO+DR$%|VPpI~tzu7pXdb@oBV zBx2>ms9%^*y-AyRS*K-PApSHtU*EVN<<>)Bnd^Td#C+d%= zUn|E9@cALE+x})QRjvtlJ7%Cby&4Z~%>24T4=VeBlts*nBA%UTP-qhmF|(_J3QbRP zPSYzBrsZWoz0-xE4UF=!pavbsM*|g;@a$P8svUJ<+^v1`CD#u(=IHT^_|Dc|)KKhm z;a(MLXPz?q+#Zd;*jv2M$-pW<7v{8%m*COVg;k>t^qL7%b~D$KI;P(p_lbFp2DNH( z-pF?9r_wW!Nd0VDtWkDcQDJ9_9^0rBw5=xYK1QJ}$eAJc%cwbPjl9BgW~HCCqY>Yi znOrA^k}8z07mdwLsK-pSBlNQie?pB?;*Jmg1VuqhU0Vxc^Q!GGxF1fG&9hV}V%KA6 zFX~dM1JRyzA!k>D?4iD|>Rvs5M4FKGE&~gwU;EI~C`tV|bMkg-iT-4|5;&_GVW3aD}##d7lJRr#A0tG)ztt zTF2V4-iPbJCPO!UF|VRLcup_zCX*JlA@Sby!2m2=c^FT<>giPRA% zX274dw`wQ#aZQ=G7Rz;#Lfs!Rp7IM_SitA;kMu#aEzC;GBd^km97iRE_SVlt8U0#? zSFh*dS!Z%BTbbp+_0zAKNnS?#Fo$w3<~KGWcoO|f^xDqm`nkrO4$t?|__~GM&Q|;X za$0Y1-7Cv-RY;X+Tp<_px(M+luID~&jZ$)v8v6^=d-t!2S-f^Uq2CC5;wAYBHB&st zzGibj#@lgvAp5=ciL#13+9c|!&lfXeNI%XJxI!#5D_)Af_90%y^WiD=l^v+pW?kQ# zz4F%P%uiHsee&mBMU1W5D}`2b(j>L^@!V*`eN9X^yrmtNJ1Dfpa#E#V8_q&2LhTga zufpBg1Alj66m@xB8~Gq&aTL~2Kiju4UxzrJlPk=uKRHw9bredSFmXm7^U=5-LWjqT zVt@u$?@+(2Gof6a4CvJKY*$K@!f$-IAE{&AXF}QIe0|uH#11q{lZEW#mq%l7xEXF! zIirR8?!MF`KYOggpmv-O^vHx+Ettp8btU}xZ(JugcSNJ!CKEd9Ie#{gxaF02xx1PA z?$*&Lbkl^-I-c`|724pQd*$j}uAlaL6nA5u9P!3QHK;eNpD2Hpdn1tjUSqDGIW4G1 z=Ig)WSAvu(!EC+CoV{aYo?~VP993O-);L~*R6bbRfj)LSc{)D7=j(jjpkC6#^SO8{ zJ#M~azQ_t+@%6uKf|dKRI@jC( ztDdn>=;`2$ibGDX%+0Wz{I{!Rb410E5r|9TT=SvcyHrP{_u zryA`z-0H{dVyzDq85vym*Lus8;6s+srv*=+y5W5~r`q4G>@TiZRNl4I99~7!&fS|A zJc{dVO3P%ae90_GiI?(w66NJplawhyZrYe62dbIn3+L=K>y;$t8%C+}Bt=}4O;Tj8 zS$eGU&1W=UYg`{+XOMsG0A|d$r5|oB)5N><=E?ZIk(;LEWLb!XXrR$RW3c2@qQZYLC$(QIpsCfAP(jXK@D;257doAk5#9mkzAU0eJhqaGqL3 zsF<^JhnzJ(_hd!Z73s|AO(oCm;mFB%MY65c* z?o-eF-H!4N>_~2x30Eldb*MjVLi|HP{J!iUW^80;V#H*g>j!yf@jhPGh+MY9j!m`i zVNSa&bO^CyPq$2LnnmpII?t1Z{IkQ3Vi*SJZJDU@R00pL1OL3d3Mx8 zmRsO2C5zXW=D$2-Zq2$fw6DKBJE)QYV>HrYgolj2Qb+u3?$R;VU*^_oBpts7%Gfzx z()68|T$|}BJ-QP+S15qCE~z-uCAt5SYh@;5i+wJcmE)3=Nz_cu{Uas%B9|a2b$(N1Yb7kaaa-^KE@M8B5v3e_T;7hLbDXl=}JOy47 zfA(Zg)i=r|SA*zn4OXJ^d4B)J3M4oEBX?WnNe=te3CvEMxmmD%if_L3uR5{^IBLU4RnDE#?(dx*8f zq|j$pIuw=0>yR&;UEv5pk1g~HPT}mPOdaOd2*d4H)IClM#oGJqmEW;%I?Oq_bLd$k zr=qSFhtu7ujam_l3x^CS4bDJ_X6|A>y_MI#W{KrGWabQiMY6v!(qq~r!iu5njV6s}CSy)IG4*uxTV};^ea|Jpxk8zcQvy2>YXMcP3c{avR zVdlaE2j;Y=UU7>9$3JCrUKZzFRiy4Qin$pd-lKqq9?f+Q;9NFwbtlZZ)L>a1u$`q| zaTd8}FXlyUaG*VBn|ul)M-@m-)nNy&hdc0_eX9@g{&`Iu=s(Yar&}GE&YXTr0gVK_ zt}p&$RPv{)kDSo^NZVYER6FY@Pa4z}Be@Y*DV3C}?=AiF0|hTMGN87%SeALnlotM? z9_uYt26L9BkFPA<;wg)kxJ%AtAGtSx8pqv@By@ncJe{YO-$!doV0lkz*~D9}3{uP7 zjs9Zu^OEY*>PvLETK4ZFR&Z5;i;WbV$B`$M9e?Com>cQ`a83vReZ(&2BW2{ttJVr^ zE1oY?xtH2@cgav{6sIyX5D>+yo8x&eJfAJfwq-I9eU=P;BOWj<;*+Ro@kY`rSg2 z`CA9io18fvti!mBP&_FbibKUC5YUDHJ~0GALv;x7(_!=q;#=>jp)AP#_KsL4ap0i7 z%z>;!tieM6@Gt|iB8Zz5-T+5`=922;aD)46|5@r9xervw$k(kS{&U=bx}&Hi*2cj) zkn=8@8t{XA^f9raL7faZaWxj*>lyIiTr3*YU>*nm@An#JtcGyzm^Z(Nj#|k91`I1i z9b*`^8B?hxZb_c&EA=dm4Cq4*O_ym_>UnI;-?k!@8B`yqrepOzD>}8}><*O`GjvuQ z4P+K0F_j5Lx$lNsvEv*0r^8lU3r@$`p*HI6IXBwIeeyURZ=PE5*SB<(e#d>A&bc`J z+>XDj=-!WW@+PID!HINCpGzFOCV90ZHVpk~#fez@re|?aZgQY9@zQ^*anJniKstXn z7>L&dIB|DdHk_%%{wxmM{X-q%nQWYNIPm4BgBY&^y57t(nk7 z*Xdv>U;Uw_(%e3la^q?S&stkKt;VNSr|XREE$ z(bQ67Q8~-~$EM)x3#+8vsB_V>(|9BJ^D5t9@8wrdEZhFrGWLp(rA_|}mg#>VY}KYh zx8N!h@3pEnqIFvH_BoaczauPBktHmx21HoK54y_8jGvYo!4q3vEjj(f$q!#GjS@}r zh5Sc!+e9h|bm zd-!609deBcYG{Y5k=ISdj6G&}J6SJMAJVZUJ#AiUoKULqHC=^GyXcSM{EH3j^}J0Q zoXb;V?GhivrTM_?AoUyW)O5@wesO|WQJjicCbJ-yQA=sjW96|J*r-+b%v!NVb3Gac zMZ@ig9{ze}Sbd2`hrnnQzpF?65Mmkg$W@hz!K|xMxKfxpnT>i>b8-%K2lKaGFC%KtxOM#=9cY%6ER ziN(x$cJ`Bvkq+eojF<;sZk8%oRY(wnUG9PVqZHVn($*9+0o-J^SxOoHlAZg zEvp?v3T2{hiA?Nf4VpSE6T66W;JF<=Ggv$FExzTX=9LR7X`@0 zm;TI^Du_}m6xbZ7z!qj`&wZ>w3^gLJT5&iJ_GF&jhje5%W=4_1hDc)lk$0JQObyy~pAUFflyf_GI&me! zL2RX=Ox)@(@5u{2{^=*%TKLJ_c0MxXOrE$!6hNItZuq$(U*07vP`Ma05)XzmCng-7 z{^+o2QW*Ll2*a4c%;ex%+&wrBA6N64A`KYc+yHM6p7q%_c=Nn9Eg&!Q-HL?yXK?Kj zXHai;!go98Lsg~Ln$KZ+PfjV#iKO}Dp?-Nw_1pe3ZvtmZO>H3gW7P7tBr~KsC{UQ0 zCtZ0DUS=k;UnS~Pp6JkM9`7^eZQbn|2ImLfQ}Qy(O z)+Oc-_M~3VXodTebcF7s9;D3~6#nZ2_D~mBpSsVwC8z~iMt#b12Le8MOHY@VY#-q- z_m=xf_7{zebp*)oCQ1xFPVYjL8&FLNY3v4tn;ZJ_^%*lc98Z>#*VquoS(IT&_N8v` zAT|9(;?V6AIikk~jN|WD?oxX%)Ks2lJ(ohhA=ZYz)DK=~Z5P&wdW(b10Nc-*;H{k) zaf5osNb)Izn@CUhK$$IZ#nDDKUy$i5q&yN%@)@ylKsOlq-Dk`I;}@USUuFN5%OhoPV%Tk5W^aYu7pkZp8oA zGkL$Xb~j5$>MmxKW=&5Rw>ldvx?3yR{L1@$Ns zhPRn`yD^;2bCM;y8g-w?sFx{lK&qVQ zT{zB{xr>}{)J%har)W^UJbj$J>x!px?&BPKafy>hjEcc8HSwygdRPycP`N)}lit*; z4DbteCDkQoG*`Alia(v^CYCP&P2){A*$Zu_NeA7YKvo{rk(hp)ZWIP#PD z@d;nteeZ{aRrHKLqJHN)^OAX&E;*&ggiA5hsU^WmT=K#|&J694gxi`V{QH64PVxgy z-|-m^Q&;~o6L*GC^GSV(atFURwXm7p>0n-=5`iwTe~I6kboo^ z=a($aJ{Tq8JawKa8eA$uy^JU4a;LI(2xH#Xcs;<{VAN7Q+RbA2=r=v~YnkEEDhYRv zGMjM%v1;Nh0UgY^UN8ysPf*)*kZXrJ)byKntZGH?=iix}O`_0F;F=kuQ)-pO*{AZg z>9Udfrbb@U{gW5D;l{FOn!of6R>?AQjKkdMpFCa=4Hvm2u(}eHiYe*iQzE?$^@AI9 z2#yNFttnx|sW|JtS{Oe6LvD8j=Os=yAaH9OJoA`!!+YZp&%tl=t?=c!_^s3#H1M!t z@I4#$4B;$Z=Kb}o&kV#6C$^iN@XXCdy;P0djn~MD!a>qJvXR`r)IhFLL%60lXIA!f z$;1!^-k%_@(at45ausOf3P)PB4sUrT7E0G)=ocNbsUd9sgr29p%!hv$3tMXgjvq2G zqaqIafmT!xw;|}J6$3g^``(To!5U|<{~ERCiyauZ#)%))ci;2>fMz_ScmMJiMUe*5 z(uvgdr(El3{p3zQxO>38GYy8~~TIk=FyRBM!2dRc+IJ=6*^>knPSG4edKeaUZs zHR$jp!+;f~+3(m5c+Q?ExlJ4~IrdS(Htg=ga~U?Y+Ga(Ci@eVQIJ4n0XWxZ!rt>5x zmTl(T%cV{{EKJ?`jRsOp=_^Yj8Zc)$K-}YkWa--gxk8^phPx62uJAQkszm)uO5|7- zs5v77|MKpt^N{|xEZ*@edDk<$YvPJH3|!58n;yhVyyM_sYXfe2Y{1$wHu&}7>2b_Y4hnO9Tkwt_tC78$ z0`U6fhVA`wWsOzIxwvkq?ctJJT_WIBoY~Zmbo9LG_+CcfR3*M%tbc;?nAem*O~)SQ z+KW}V?r{a~Vv8E-a7vJC@TI8eRj2M95U+g+R}#GYsNXJQl`{G@mP z0QoeqvD9UT<*9Vep8lqi8w*&A{o;G1;S7_LoRM(PCEL>#_}7y-({~+qRqTtSX1-sS zId7zq4v$a7q51~uhsf0@w%LGAe6Osl<4`V@IhxetHtuV~#7WHd8e)UJsf}1L^ZAQ@ zKqBvWtB(_F3exY{p7RKoCrQsZ>dpHckod8wqWzpGeOjkT&089bIix|q8_d?IPtD#Z zHBg8+HTU*CBeP33QHvi+ogB}j%#%D9EoQt>GT*!yXA$PnXMTx3^eW7VC7#*-KDB7a ziGOnMFUn%JuRH5xa?VK7&P1xjq5weF%Q$jc!B-JAm*-LH$#_8 zt@+#}ESf{@po@8X8fNB>Cr7+76U}*7RC424xP@5|M&=8z=lnHlEEk+6k9e2bv@B}V zID>n~O_MAc!Z}XNXp}=Ka)+5Roos5%U+M>Ejt1R2Q$JXhnEFTN5N1Z>RKaMJtQLbs zo-tTilR1q&^*Ftf**3432TweC`7QeG6OwS@uOw8?&BT_c%=a6S31bgx_c~{xgenv7 zcqaFvUN4Qlg+q;aF7iy=yIP^$m7FYHW+Zc#;C?yu(Ihu^BuSPzSyFAj_*jO0+CJ7D zi!`9O7Jb>< zD|dsLCw!keLF#T2UT5QbO)ojzfqK1Wq3Cj*o}@_PLY~=Z8tW~SYyFXH8$7MiiW@vMq)BsiOwGvRL7EpBRmgzbsGs zBN^92q1#J+pNAD|Ts$N8SLa-b9BDm7hZn5bPj;hDuz~}{!|KSV?=ItflD1o+ zzRPp8VSOt$7l`k3T<&8T#uCADC{W%t@%>FawzWb zj&E#8$56g6`V>V^dA0` zeWjJROR_pLuk8%`ZaaI)OAcfVV}8FjN4}Gj*f^0`rmq!t{=E7?Pgy+8C3RCnnc2wR zW?ni1r}OzU)G}dGzU<=rvb{C=2I|yO*<-~#@E1L~n@ykT|DaASlHYgZe?M<~m5j>F zlfm6WFq!#!x5xzyWIr~1ho^)wL!wAl2ux$CJFCw=j`#1K7HT=OGDrIE48^Wv1{j-J zG0u>U8w=`*W{pe6aa}EM9gCIysR#T?zw~;wd zd5t(5#=V|gsG2LoRu5SUglFSUa$Q-k z&6Q=*p*WC6j)nc;*&*3@YW0<}2I>ua^@gq^ed}B&_DFga`npT4qPg<&Z|YrtWu zeHO$*3w`#H+{{1ns4IW2=JaB4{k$c9`aZR`{Ho7+mn5QRm8(vr$e!TwTG{_l)A{?IF{Mdh{f%boD0P7+c2u0EFY6A z)3$`7wY%Yexvphq5(A#(Ek{1)$$~Lq*w3FgOlL*8ZtrpLL0!4PeY%Quq~{*yY!0(x ztdsiXNN)*#>5@-HIUm`VIgh8Us2b?NDekY0e4dIq%#D3b48W9*bspI`J&ZN<>U^n0 z-T)O?d$wc>Lv}W1p7jtV`3j9M^{rD`pYKaY(>I(8)UJ+9oRKSuA30wkpZdNtX*ff? zde8zdF;fqCS(qadPmJD+oYPctM$|Q5OI2WyS15*Tj)jqY)-qzy#s15on8H~OJwoxL zya5Bkt(fw6Hn|~hnK#NMkvSpopFj>EF&zc&WW(CcQ_Oq+NGs+qOpY-id?9mG#}MBx z;v?>VawUFdC?00<^6Y*~j5D@#v*XX-BJ=ElWSRZG6Zjo2At-48&i|BJHFMEdwiV}9`?cJ^~^XaYK7~C1OFte zWrOpl{7MVOJcR+Cb*zYZL7j4NU2*u6JAEF4E!C*YEr!iUlskC`J5{)LUb_RVU|N_8?L@2S5Ple zI&ASlSNCY@1E^~YWnMD%GRw#BlPP;tC`nBC^)vG1Ui4Sjqdv~DPoC9Rq1Qa(wXAto zf6TzjUJ7jidKrD0s~D6_ofqqmCnf0FzU{(@-NY?6s4?k$6h>4}LU=3Y&`~#6b7i9J z{N;nwv!hUdv=Nnta9%Kb!&;$cIX%W3joRqRvvLkWIqKSmu|C0Gaqd>3jyVd)Y$jZ< zO@AZxL^CsuvSyYKzPw^?+68(w-`Ej#IUfzuiQl(jPTYGvI;zd6+a&|%D%00ToZdi8 zB8;`bP4=!ysTn9xRG|$^Is#gZK zEps8pmMG);tMP9adNddR=drgVsJlXYr=n5xPubfSkHJztf7e$TXg)!q^`&kuU?j7t zD(dlJzlnDV^JSG&rE{nW+0m_Qw+ zE(XQI>CxXxk0JG>1!tN>(_D?Q9reg7L!HqS>iE)Jxb)sAGwP{PXmm8zyNF$N$Y54A zJvc3rMAcV~CxxT2lJ8^ta68^5x#01MKkt1X)OXPL8UAFS9O&+Yzzb1`szfa80dqnl7223w zK0o!jtD~dg_+vsZu7}yIMT=#|%ZD5vY@_bQtuJ%AhEey*{$@fS@Tu3r ziOS?$5bF4lAcGsI5tsP?k@nS5ZEoAQNvXTLAVrb@73wYRnyI@$fO<=N>h1=Fx+_w5 zBm#9O5U9Hms8F}lK;4VIdGBw$_r`etzB>k^=LSeZzWwdJ)?8CUaf>}v{ASjdvzc=p z7cafLyJIZpBzYT+2=b(#AbDOck+EW&=!O%EsjsbR!lla8ijC#<3OOKO$fHco3B|(Y z#H40%{f8;E4=%*Xt9vR;xl4ZB7J7nJBIdn7_jCB!_;Bi|L=ZkUUwX zkva(v_>eDLsS5Q)lWmxrLBGhj{W6^E*{5R|n)7vsFC-t3yx<$=SXp05jp_Cf zJue-LE*GL#>Otuk#TgWPpiX<}A5nyUg^>klt}@A*01x^*g`rt7os=)Miz%_Fyo;f4Ps5$GTVkx6&2cluNY)~ zt{PT7^-Y}rG%rYpofz5hs5qJ3Mumn)nRg#e-$@7Zb#4~IG(AS1Tp?!pA(Wm3MqItl z-0-sGrPhj-Pj^(<8L!7k^64h=zSFUf8;Kaf3=PJfPw{g8gt~6Bf@Q1{tl;9#+T62G(%JaE5t7)Ei%cCi8d6SaJw#(0@%r_b+cdgHk> zpM4$kqsjBF&gZZCh~9b~!mvz5e-cmTCX`lah2f(|MMBM7Phst=`zl@%8JaS zj6^3(?-LK&wSU~xGUU=BU!6W7sr-W9mY~RimWFk&`+lrZKY68YMAF{THp{{y|0ZR2 z?$mZ+>4la{chW5<%O7a}`+lb7Rmpef7Jo06{A%?|%hWf;+OIoO#Ztfh#-zc2KUm(T zeYGTJQ4gN+xlmN9yNBvC_Y%S!(jWd%{eG@imNcal1(t%r?>5 zFJ9(vBF}v&XWT6ea_4Kj^b6tr_KBXiX|a;aGcv3~jASmOuj3wrgwHU@h2us!aw=AK z4Pd5V1*44Js(~x_otE@ozQ0P1>NPa5s>v(u;|b$-dNG1oRg1}AoK6qj0&)|ZF)z@E zKD#`7gD>#Dvk^}Y^}r5#&i-^DC$T3rke|s}+(E8>kOpDA*Ivz`=MMdOKKCV$UZ+8E z-mk73=-*g^{Kg~9oPOeo(YrMG_a*C*iD3xYM2zaCo_;&@RxQnWGS4vYXg!oa>A_k{ z56`#s*m2h5dL=!1P+|B`QIE98p%``{47pBv{HPR;0w-o{kdHW}kshNr5Z_+FS@xVz z>X<{}QH)skV?D8ya9mkOjc8C9HZRko25X*g#ODv3U}m*T7&>@x?;yT%^ST)a!p(4d zVZ@dx^u$?WgnLC3f->n}y~u=RW+RrW%}8#@d_m$M9fQqCy~_;hIVQa6!;Jb?oMZ3e ztebVytyAPEcIWrFm!CXkLNb5eV;p&rZTWN2FdMa zJLGJJS8xVgezKO@OFwESa<13fP^ToZvAdifbH+62cLq*rZOG^S`I~!2-y@muq24yV zQwElBj^K1L6X%Jcg^&~JXkjhFb8;7Js@x|wL=WNInvXp%%lxGZ8HnD*z3VyokvmvZ z9LM0BBxk<&FUZQE`D)mF0C6l_Q0VDaCu25Pk71)zh zAf1_wd#*hF;(8Uxp03njO)8Z1NCozT$vRZ4+eBc7}*tHgjE z`O^MWp#-&~4y%O%*NZ6VZBiiL+9?sapIj~CyKWu|45`g|0X1K7#h5MkvOvP=Be!t4 z0xlgDSeVRNxFa9S^hdAdoTvJ-54_`t=;QwA97K(qRfnvjoN+42XWUG0w-|q%=|dkl z_BRQC{INw9z?>R?be}=aRDVCr*~koP3-h9O2H@&hdi4i0Yub%IK^4i%Ivm zB(f?;VZplyc+RGGTr&Ib<@|m2&)p;nKb^?m>JovVYEg)p!nr_s>gHfS%Ck4sxh`Fz^qRmX^)jp@*t~q%S3hEe_=3wYVJF*IyO^{75h%7!y?6uez8;Jew z$;P&HJNl_|FqgmAOr4Fy_u07cm)|>J$H<%6a8YQ888?y=i7J^tL@jfBc*&DdF5;nV zD$}nulzVr`<#lA%GqyM4xYkvAK2u2;^P{sb zxXSiYE^;ujsjOVtyB60=_9OY=R%bM`2(ZXENw{wz!%~H-#c%Rze7Krct0ttRnAk7x$$+cev^671% zY+R?rpjQPlQO6m}LIr%26fh1fkhj|un8^D{(JKJIj|bojHHyXW1fXP)4v8ZIunGQ{ z)WaVmeRU|Z${(di^06w+i{WF>#s@H;YQTRzr2_Wp;8fEe1AY8apSa1tXsC%45k5vc0wuKoh`NUm`p%m6(ZnQQUKE!et z^Pcf^j70mR?B82a%Q-I!x!%MQiQ76|CGVwuB(|O>wo;ECB=4Ca7DR5tFlJJmBj5L1 zB!c<%dltP=|D_jWF>-{5ko!0-5|~KbqFogJ)pHg(h@Kb;^ustyj$=pac!hlAIlMP} z@G;_S6UV0_ZFwqZ_SDZSQ&Hj*^CE~*g_Y)7C!ggYJx+=f8$7s>-Xd8ks8cQ#7fX`I zQDBAFJuA|WrDDl3em~g?3`s>XM=P@GlNZyQcwZmR@Q4?UqjtDFRgJeUrC>kr%@>^U z%_dIh#~Iek7vxTsOu>NVydP&Udn}F`R~z{Wej;`{!lOS?&Rms-{>m}&WQ`&V1ij+kUB*PK%0J9w>E58%8Baz$vq|Z)TJODe*F@NP^7R zL~S4Ivo<<{3k`BFMT z6v1Zc??G=ybDUgQl|W6QS&lle2G5U`lw)yHE1&wYal{bz#))6E1euyn-^L|IF(eq} z#G_c^!5;X1fwMASdTwX4_B%k#!jCzjuQ)TSqDDg(HOhFaVCVOoXAyU?s8D988eKkX zQ0uxH<)^ARYw#eqUWIol)VP$T7Z&k{rQV!L{_6?#W;N1RYjAIYhWvOH&M)NGIt_*| z_QVS(4f)GnC{@oB&8efw=f6eRPt3YY53eSAYW_lq(Xt*SmSml$M|0MSk(a^{Uzc8r zC8>3ZptmAtW-ZOk#&qC(@jP`e)Wa?2?`rt-M_ZB4Q#Kquy_g+f3q@;U7FUUfseA7odJO#(isZa-M6rKs!yY|hZzz604#V!_Cd}qc?#BZI?rtNl#G0>1 zJiWDJsdX)5hUJVArnZ->n=tab5iz&e*A6$L z*gkqTR$?zj+-dC{YU}=`pUYPxvNjp9ygB`*nv)+nlyk^56MDKB@w^E2q`Qqc#@C8g z5V!Fom*#l}ihpI6W(@N*I?&IXe8fT9nQM1A16NqvZ8*p}l0BbYn}KJgGBJ;jB@Sjy zxSM&hi!*U>mJJQtW?L9J; zO8zF^V585soqWg5w*SLt-0a*~jO&=qo8~SjS81dLxrDbk<8mpjM4dnd`h_SkG`CR7 zv;OjV!hGfUK=ip5fQ~f>p@w@9o@WN)^^QP#Ek-eOjeB1<{TYc@7v&87YjbkOf3k*{ zlL~X6RP_48nNLHW@sEi?tFlpPbq>;3@=WHLedjzq2z+x8V!-(5AZsJ#&Gp_?-*ftO=Ytzeja}=fy zi^AzGQLHVZi0yF?e@AZl0oE3$xi8jC!>7Ymq`9Y}OdWbhbKiUXhV!)6InWXxkFC!7 zU<|!vQ=7={d~eBcQAuU;2m5qU%dbh!@^Fw6qcZYjB+c)_1$3la0fH@XigMbex!chF%@q(gEM8Ok~dFo$PLy@ zZp5rFvhKJ{PB?3tiX(C`s0DMdi+{j^>OSK8Q6nF}X{0SPqQ(V#${CeLes@>k&3yVM zFIJ-G>LLh_D3BV{ieT!RKosrG45l9e7)Rf&J1qmLsU_d?F}GPAi|I3jW zVdB|$i}hS1aveNVvF>atM&$5JnMG`UI{Az5=-XS!4AB?ai1sEnpFv-TJB{RLq?`13 z>LtUkwve%op0fD8r#M|Jlol=M5lIe)jl7U~2@d$#NP#Eefmp2%z*yG4l{N-plR5x< z4+SEgHR;qR}>o(*xF;ompQx(kpuu`LCVG zCvqc4h1crUJDxRDG;-sim+T+wAvagK$>c98@%Y(ThO$R+%2#5=a|Jy0N(9@K7`Z@+ zedhw;dy*bkr-JZrgMs+HjC0pgIyB}CF?eefZgLGZ=@x}gzLBV#5QT}0Q_+eX&*o23 zQH`I?kiltqTa7jHnrz%F!+a|>J&ZX=IY*w;zJ2sTsbP}S^slSkJYKrHnWe}JgD8nB z)NHQ7OYXUqlF2vk>`6~?Z)huM;8Cc@r!aE9bII=xq`%dgaEvO#d;;!48@c}^wlHJk zUV6!%p#SR*;)Ud2Eb+?3(mBLsT4!Jy@A)@xnHfxuUeoWy@5wV5--~ksYM8qbFMaCD z*KZgv-Dby&+Se#W4;UppJ6^u`@Pvzn8phsU_@HfsSqGTy+){;RzTtQr9ge5d=}WXZ z47Q%kRcN4xGkf973rz5{(l?3yZ{9ENncPD|8*p#)WiLBC6E*nWTK6M2C5=5Vu`|m) zg|;Ozx^;D#14AtN^Ct2vi_mLur&)%O>lx&nAg3-fM`gZID!G$S5TM57isa&_d&2RB z26r4aP;k$mF+Utb?$MudgC5mdhocwqg~1cZIX`T~fy4A1{A0$)T4wzIX@cuaa=giL zSe9%eU{ds5;=S9vhXO=ftz%B1gVG2Uc;@I5yvx`zE&PX!*tDbe7p0?B_BNdKHC>l1Vc z$_qpTatOmz1IhUgfIf^l*!huoKA(QIwWCm)=hjYs9Un|T_=~9+$^E$wJz=*vq+v`m z_RSxdJAEM=<#qHPd`0aM_v&@5(OnGmM!f7Tt6dsN`R<;Qo9-gF?l+Pa``zVNav?PW zg>s&}y{*JsYSmKWN^qgPcMHVgvjOO_mp+j{1IRZB!1!-|2qu3qn`hX-B=$8AqwuXN z_vg`(_|lJ`N8eQJV6W2UBE6!7y+tQ#1#0AA$TRu@mB_&xZ4Npf&&J*y?$0;9#rGd? z=|JDXUF4shF=_-c9#UMVL^tls-oJ`qNi6Xn_LnJ}c%~KT;CxSqokN1Km^m5?%LQV^ zd1mPqaDV2$+&zLGSpB0ghv)s1_B`kRNuw4a6;D}fj6KY=b!{r1g;FC{B?nH$$Z2ew zgUs2?YPe1=!`2)u+TkWk70fJ&R*U=TmXi8jEnA`+OVfJPz}};`r?V0{(F*n}_MeYf_gthl;0^1bH<1`$k3Nn4s9|7^;r#h&DF4}t z3*-$hKE$=t-imp|7OL>P>P9`+RweTodA^srN1vWI?oyn7qvsxLuY)J49F7}vn4#R?4DD9xg*aClUDCwb-G~Xb=v&@|Gmd}^?(fX5QDtHa@Aq=2 zcy3*%pK!WDTScMNR^b01Xj5plKFqsHV}@J%1bLz2?0W-q)h@?M%~PK6{pbbL4-Jm5 zrLS-=HBPZ7+HR+}-^y?_Js6HL)55Xwsh%3GP_)sR(T_F!tSCp5w33mgHV-exT51D(GMG*eEmim}JfugE+NJ zkP2Fp40BAB>YTl-9m7^)g}onF;rOnK;V5@KPzIR!LstPx`~y z=kmRHDYQ4mET={qC03mv_iM7B{F@+q=v{JcswY;jQ)3%zjQ{xQbUo*V=XaThy<3mh zoB8_MaBNA}qtO68h6L-OElscEh2#??^56dSJa#2F|GW`8>J?s%rY65`1}5`bMO@`s z+9Lzy3KZHi{izM$Os(2)h4upYUZ_`C<(w$9=O&1aJp3B34$02*N9em^mbXhe)7Ywk z!yZr6W&U;5ZJak$_C!zmA3o0x$DT{{_3RXmHYs6vG?jCKWeFH&qeg8IeT6H~55FOM zDb0)5+Gx6mJXI2w3@u?_#p1qv)9#m-0l~!t>-BoDSJTLx|hq}DKNhTCE zN~uZ)sYUPOErsOfIvtg-56G!3O+IC|28E$qKV!JQ*OJdjzUP{~dh9tBjyj*{H~%qGfhmu5=vABy?rK?Htw3ayAAXl$Uh~ov zRJp*6nf2snaew-@$PX2_MbN7(1*eFImKx(MEx5POZb>cv03uV)yIBHXxNutVlN01`l~UT!D=| zLzeS>J{(AV%EgX1Yn-I*0rCVhh~XLNOE@qEUnbd6ceArJwB*b7mCRb%#Qx}3GL8~| z`eRVZ+A9U(bV7$p{`7@>k&MgF?1)WkC})}#%8-tJ*cVJZk9+;|p4rH{;wm0B@}2k$f@k;|EtoVB>b;V?4tx$JEk$PJwu{XRDVLfuY>5cl@+t zS`X$?5mPPmi~a*e$WsgEURg66_~9nIcI8UYYJW^1Ca)*IugMDHUi%%T)~Et;-RO^w zha!;MGX*EF65l%GD7g&^#Iw9VYVV9hpY6%04r0+c&N8nUan`QPWuDLHaZJU^q-=cV z9A)>_LMhXbe91HH&6-jd$mYqeB5n5nmeXASTPrhndlGrRSL|qhl-?b|3iKJl=h+g8Rijfdmd`U`XFX}_ zu0ZE%0qDTl$FpDbqYTVOlG0616Kj}e^@Fu8d-j$on3qJ{GT%wcJ^w37vzXDw%K_li(Pw|ko4e4unnfINJJl4CsFV53nuajE5evrp^Mh6Xfb|a@# z|H%8R{WZQW^Mbd`q^^|f(~}r-cVenp)f>vhx%6Fq=7+QVyYlia&i{I$9gNZ-bw z2(BM^VOEop`wsGvStpl?_K=FFa^-}L z-UhtB=a!M5ILD4Y+tl)UwE`^~_~YtrUSH0JN=Mk~tL`R!p5;nwXXc5M4`^A=nUgE| zq?;ScB=Qq`^weR~NaF9im=Au|j<)uOGN&E0rB?c*WK+(%dXpbIJR9}-J{K*_7w6Od zDC9n)Ab#-vAFkWs&QfGqzC12Uo-#iluOn9U@67eNTO&1Z{FO6#0r)YO{KslmG~)g+ zk~0_&)?0Hc1`!93fZb%p=o!p+-t8_1KLwU8VxE+qx>;x9U26Jux~Qe+pWpI?`^=`> zynpA?>tii-j_eJ(uP^_$-*2Dhr;k@n$Ys9Ha_7#K3 ztJU(p-WGtr?vZ%l!#aDmow^3{XVZSm^l%-@_KC!uF{~*=ImbHQP$m?ie}#^9a|vcl zJWWCMlkaijzLTVJKM$#@L+GRkD0u(=-9_Fm_p1ea^TgGK{<$l;Z*W~XwaUiB9o3}& z^gNl)^TMwTXNmsw9Z9z1rK_`;PvlGT2|x7Yb+1{8vj(Fb`-zKht*6FYtsc2kr~{vz zj@{(%RA#N_9z@?pdLjL~WW+`f8;W-#Kjnx~dR|c@@=z!qk1h8Rg8FT%-*zHjx(znj7tI(a~zn3EpPk&F6XDm;F6) z>#Ns|_`#n)w7U>psu|_^UKOg>qvmA2i8X-@{ofbjT5h}y>O%iJCG#P&jo4b7xrpqS z>qZ;p_YW1m(#P$786#G&q9(5@`EF&*vaYd)wH|$-4jQ0{r*|{|t}YMgldx3<-^t7u zE>A82aoWFC6xy0K<0ZJVJI)*mLz5BY6&AB$?~+39Pciagg&Hr&wWvbwLFXd$E1aRw z-YsvIn5QcI`)XXa>cx8Y$WK0Y*7j`(?CvorY= zHI3*}k=c-}O?33?ioB{qy(4;<8yRuJi+Qg-iPQMdSCLtuUA8k<+Qo!9rRmSe8gIa% zIMMXuyum#bwTKCo_{Qhisn8z1YLuK;9`qlfKV44~yj?P|cep}ppx0N>EDb&7=z&#_ z{0Z=V?jnzAkU>;;HTVoYdc8E_MQ0ljtI+0LjTgs24X(M+FDrz4%;`2%n6J=w@`#o3 zMm4?OsAo+vQP;`b3u0cf%^<%A(a(!BfZY8?=7=!&i0f_X<5+1sONDBwp~Nrg7kSsl z+&6`G-jX;u=B`H0Aw71tB>phZMjlup+N_I{p=(sQdM^wkZjo1VEFHIby`Jo+&tNYP zOfrR`Kur&Xem1;f-P?uv-Kj2WoZJ?Q6+3x-HDod}Ka?nHVo#Rr zP}H{?;Xj%A6}-N$Ud2g|95q5JQ1g7(fNM$V7}1aZm0|Hxa=Qv2t1_Qs81sTB+we|R z$V?rh1e9Y|*E#Zt`x`OQNPcKHg?4h(L3#g7gV;CpDC@>`m~VsQ;X;H~HA#`<9?;d& zGaH9<4;A?=e7w7o`Px|;9QqiFuFDK?IFOFfj|wrcb(|C|Rbd7_%hJ3#JK?&Geo%;% zvIe=gjq9YE9+PU3Z+OUt&ZBs}Hphs9pU;3PeQu8jS7QX zHTs3zRkwaVPYk5jfzi0Z8Zb-*SvqD>& zJmp@zFBbFu-B-?tgtqBWu2pDL+Q&)mN_SM@{BW8umpq0%cRo+j)L2~ zZ5D~s?y|NFoH_y7ODkN@X){?o&itZ>w_XXcRP;*Z*#dswZvZ`XTElO8P} zYzh57(=zvdmc?~a(WJ`bu3G{>lubVAYDx-qyl2_G(K-33_ZZ9WTJ@6(XWuwib;vi% z-i5W3o9$a^30N|@UHjoz&Mh45ncPP4ASu0xi?4B6>E!YAuO`*bOHFbg{l<5G>14~S z8aLWaDs{lpsq6iA8?}$xecKt)cEPmyN$u1JrQVr1v6qh%YncS;PCw78+l+FZzPz7S zbFZpNPaK}XYk!%=K&@fBVhK{Kkx_Q7iIduk<3*WA-^N)+ImSLYooC&fI|pP(<3tJI zSNnO1@^BZ=#Y6EjXG4O_jxo!nA;j$I^*G;&{KX-0vi)t0TpDbWeu42)zp+^~$J8h~ zg#L+r)mYJAjeoxJnsJ{VOz)hu7;+c`IB#yEf~krp7S~YYS|@rmJM+Bf+Sxr=gPQ@K z2(QD;D4t~wS!$e5BbR-p7hYFqhJ8m3vf8LICWABWVDcUtY2bL4`hK31Ku8|3E#whU;O<4a1v<lsbCP*l#OpXw}f6zl3ynR~O&MxSVE5YoDbBj!B6Pp)Ko zR0y2=vaVRIM|s{K$1^w&XFXw9Ms35IFk=7AyXt9%x}+JWw{d3i%79=eBkJ5Y0{7|1 zV=>}cX){v3(5K-N@rJcVYju^u z^L)sU_9Q;^%LWDa(o@+se9>~x_NQOLpbWU~vf)#4W)N}~@|ZQ(d18SBLb>OL^R-Xg zaE9mQ^gHPozs6m@-Kj55UmD5|@)SQf&@Y`{is3gJ$c=!8@;*f^I?hGCiQ{hjsh0kw zG&0WWCJwupqu{KPvjbg4rFWC&gWcuJS0@=z%U!1RZYnb}ykvWbhYZ}R5sPnqIr~e+ zTy>31e(NkgI#*dX&`qva^pJ?3ZZha!Z>d|!T{e2Ti>?E8_tV(7A5>uA_X5$9J5_zO z67!E1NHq0{f$UiW{>_t5{h8lqQ{W(d;6{I^-fDBcoFK>X=hs5&!I=BgT7g#NKknu8 zWy%A0>!w`%GZZFpC}ww{-M5)M51jKlYvh*j$F5^ko7t z@xDJQ(i`%LU59SZ{qePv|9>+UmdDZOKQ971`bUt`{4{K7i(tvKOnMb&?p=dhjHutf43?@$}N+loG`tvLUQ`4!DmFzb>P!M^lt zuv+2T^FLZ%D<1IYeJ1i}W)o8%$hpHqYG;YFzwE^4X5W33y{pp~D-NVs@wOg4=k}#w z@zM7%_-2y}%o+OGY|NQOjuiX7C8e|J18B#&-^`TWVn@?+w1EGMRUio~g<+8KI2z!GN`OtRx!7_L3=N`w5qXGEblGnD=F}>nF2Sz zEAaM>0**Tir0$%*61+@-wT+e7T1J6cp9*9Bg!JVJr)g#}`q zp@1`ajvC&NjyDRWdq|-qR^vRdJ#~8X3MKA3`Nqt9ubjpEuS&k`KFRy}R-Po-^Cdb$ ziP3G8^gSZ)WE}5T-vKb%IQ#kHk2+O|S;p!x{-Zy3b~&? zPwADhjeR}u=|1IyQ2H9Rw#@7BAMB5A)%-EBg$~a(QK++v_fiRBbec#c6LWn;PU7xq zk+{v7STO%BX(ApJAA#MR)%E!riH4UWVRR(tmzmO010qmkCUZo1zYQzOEH4}H6%~1l zYa&rSm-o^d`h}d0L`yGnA-7XcS}_W7p;6fOAOiESh8BZmnr7jhRV(5eRAq9q}R(zO9&cy<9Lk1CdZD2)( ztQ553{WX+0NP0NAj)I{S0SpT>H1L(07XXXhAuC?aXGT zfgQiPk~{3f3>p5+gErK@&(6jMVqi5}GIx*P58s%L9a(m?Yfc=hLJsyvlK)8l$qBn1 z*H=Ir!Dv9 zb+jBf*V{5`z{8}7iF!+efqN`qCbdsWgk?(ChL%MG2V1ghu4tF{B;2>iF^Be}H`YlW z(Wy_8IV?Hp_T5ds?+X|CuAd)dIsGP1njbaDi!%nP*wP@;l?`&-iJBqiTAW;DmVx!+ zWn^5ONNei5tZ}kDI8HkDh>_l3j8cW%k$rdR|2^Qa+_@hw#i*e&*vJJCer@8s&>Sxx zse6e$$t>%6hov<=t5y(4X>W>?=+~?%H^)l1k#RE1Y?f)WV@0Ph%0I>F5A|7%rhPe| z@>C(>g9pylW(G9pFoW6uoS}EO=`FpzEgI;rs*%B(FIc6);acoz{;JTYf(k3^YH**= zQSF)ng+j%lK^mEwP3%~ zk(#?)4=gRO$IL~cC`E0G-_kH*M|!*n(Bsb)au&ncJFq5vOV91ap<&E+rFKk74&#?F z1kR!N*SRo!ZonF^nH~$W*iSE@wvznENp_wqTqum(MHlA1gIOsU@N(e@B8cxb@l14c+y8`d~*4%pjE8 zDV2fxS=11&q^CA}-6cQi)%}!M-!$SZ-!rgciVdy{_}IV<_>^UDZcB$tKW26uWNyJG z`YS%pU_LHA9A8m)xygnxA2YCYE-{Y1%m=y2OzPz}-kan{*5~(zWFUJgGvUf-&^y`2 zx$*zyGakL{BQNT!#qEbXeM3Fu>@2l7_WtA2_akQq^! zbu|*>8q*^;)rwc#OD~p5LyvB(NxCzWvbzr*z!{tJ0U!w@l_awiPy#AUk74UWsK(8e_taTZPhG*yv z92|g8JkyMO=xuO@`+saCo)X6{)`;2@)_23tSgC2X;zw306x^d-e$yW%jx)tU*%+9e zjWU_pc=3_G(3v^NYr(qbHu;o2RgwbwR|YY=>kH>_7AG0RGkVfpp8F#e82OBTTLA^K zVxWTOFMW%52BOZLAT&)5!k#|N$mDgakrIg$)uYg93$NGaDEv6UET%dCGmom)HkCPy z)R+ur7B_3Of@-O#V$8AVoU*(U$w&!x?(arWXEuSonXrjUib^WH&VxuabLH)z$1(yE5xz0Qrj#>BmS+xbkv^Hi{UP z=CnfF`7!x$^sMyQYLM6TwkkrL#IV3D3(22ff1009H7|5~LEph@o>=SWiI#qPC|>JP zSY!ROK_tnfjWM0KA zPek~5VZkM4G7Z$=K!_fblgMKXrO%cv9Cya?Ji9?I|7e~!!~wrfH_;1#9E`8Lepkpp zeN8?)_v5Hm%rLD=E(rCD=SNZVK8rkutMt?)XE2D|hw_W53I7l8^FxB{f0ZcL^3C#W zMFO)J%`%KQ)9Fdfl;L$coJOyPdHm|5Mmyp(nbZhW+0XUUD;%5oxhzod+T}Cz`L_w` z^=33{VaBy1X6R0s@Gzfv;R9wy{3RE@+5>#!`uV;h10P0`LrBg=eNUzKgO%CN^_ALy zvPx~YNWMqM1bO@Os1%$c1{PwLmzz1iaWTr@Ku@d>@}LSRZ8uhdDNeCcJpEp=PrX4+D!vFPw{Cg7h@XB-ilr_)=rP%3XNp4dt+%+$pOKk z%z;xY(fg+obG7{M?$k{#(-E`L;gn|(ZciaU?i0Dx4+HRc4)5*Zc@ShA=;92A91b)vCT%^sS)^|^E_JwBL)r%1&?ixnGqcG~-pmyu3= z5OVOI=h^4d*+{78DvPIj$koyFLg@W*h7D0kKLSk3XY9rNCQ_H7}QKwyEc`a5MoY+ZgQ-E znT9!$dh6w5v&ekJ$uaXW&$erjL#q<0QeU3Lp;nk@q zjN$pUXhkIU?y#b~iQJDZsW|%6iovI?xcbS8P*-|7HK%vwPLH(b|c;}+LT zpTRlsn!~P+GsJNEA7;+r5cSfWA?nv}J$oJzDO|ByQ-qZ9Cis8AQkc!E5 z=rL@!VtbKP9NR{ZtcD*@dqp;?Y@zSyRn}#%$&r~szt0ATWu(J@GP3B0!d|BC63$7iy}eXizki{VN2CXJMXC3~T$#1;+_UfA-M3CE_Rdn z&c5_4Ayw_Z=S@JJc)fW4{D+(g7q34<5#z~q1baI z41EjflQ4@tCHudr!Fs&jO>dP=37AM+|LH3emc~*iu#eX(kZUHw27@1YohEV-NpdK4arQ&Qhyi zo@^uUsqr87O(4dzow!L?cX>KqiPPkNIj)Mtk+M_FpgZhQQdkblUxB5qc^gcS}I$#rh&DO-={OZl4v&{rFQYQ6bB z8!@Bfa|8OU1a;Dn_+gOPSwb){dw}>upf>TL?G*P3ijP0-gB~n^d*jH z9>&_A_;pEd;>QQL=OjAG$))*%lm2K|ClU!CQ_%S*aaT)2*+%?w%d-Jk{Wt<$E|Ir* z&5jq9-K6J)ztY4q0GDes7p1xtj zNH#hIHEEYdk~eYZE%n5w8hz7F4#32Z5x7#8dAN_W;Wo`#T9wO{ zem=~h-cHZul2#m^la1jwoTXrHf!wU^k79F}vrK$EQe#I0jk^q_-{q4h{uuc+0?*S@ zP-G$Vo!y*ee4RYm@210YK7Tjz8PjWI<4FhpUG(XDyibRp0nD0to{V#&=+pPpMKS{N z#gCfuo4+IQxses-PIjbhbCjds3grH8e~i5nfp>%XIk&N6#4=C0YgS^)cYj#&Bk=FW z6lC_Y9B+TZl$lKAbuQu>z>z>`Gb_0aD$lz^ks-OThT*7EO48PtlXI^10!_g8PYeC z8tm{F%quVICgoQu(2YKogQ{^}u{s4)-`erVNh3~irO0>VdS20#ewU9@kiojbaJ!CddsHYBI?>Z0jJW$m z^0JMrS?{>W^uR*V*6>Hww&V{wSh;7=SNw;gENa5s^V&Lcu_DnW*NS#VJLZ)luaI^9 z1b#lN!XuEVPr-~n)Db2%7R8=I89RwHglMkMt10+EUf$0MUNUNIp*+j*C$~HTfBzx> z^bdV0`n$=SdIgfaioDK4QE+-q9xijds{=@$+B%+)3IO=1S^8e@uQBfw?`1ueT;&n>qDQZqeuTtUuHbn0L>= zclH1~bSE2%qPqf1dgw5Kyh3##GtbuXe!O2#bUq5Wdg|c$obv-G&dE;MQN5;G?yV}2 zuqFXm@rd5>#uV0=%t6vSOFsR=r(ENH-b3|BrOLrbChk*H0(T>|&T(mRDc=w=mCc3O&6IoENgksm;%=_GdS78>+yq zTl9KaP4D_HDLAo+xKB4{aa)-y%Z&cGk;8hs3-_@QJH92x%gg&7&8Xd?YXj~rp+1pk>RrPDdDg)LPOM?PrjkFEM?P0> zAj35ps}ktyXhC^snE8VXArON9=P0?J$XG7LdIkusUd5DP5Z@OPla<^ zsA0WhK*b^%I6!{T+ac7PZgR%}XZk#@GNQ^{@{A@cw9CV&M?Iy&v*lrUoomFK$#~hqeBK^o$)o&bz*1rqL>ipaeGjsC-d-)dBLb49s+}9vtB=5`?g2=5Vq>&GGEr|8beWPq2tHvZ^H@;iB zPLk76E3^;>YH!qCyr|(P*1y__PPc6+R)U}NK$Fz0uf}>u;ykmB7}=g)?uQCd|2=c4 zJ2Q)FZWy}rb(4v2Z+u#aj#HR#zJR*UhG9^&HzKEv4dx!yt&)$aD$V=|K7V;1BUAEAflX#3z0;2mJew7}>Z{!#to+bS_4Yh>qM07p~98%x*oY!tpZnXLMoCZynb0 zKMK)gG}oIO^~{gL&}yj>f9&ZW`9>*)z<1a_sv)Rn&QZH+Q{ojVj& zLNR?2=L*H?nZ=s_H~C_Vl6YOX9^QW?kMaolVhZ~1xyQ)zcnzBMVJ-c|h=-$yd37LP zue?z@{-ef3^6bVwGoZx|a!!^O;`Z`5*%+us80RqeI~#FwD19wgv&ZNaBSWitAn!8y zXk5?JyvZXADa6H-anikk2QG9E#ZBT!^@ux;(kisgTOE*q!zwJ;5<<^p1OBWe|1^R= zkM!tRy;%kC3Sn65U_$W*HgqMQv{Ei}isRMD%v*#VW$5!*H{-v)iVNILvSbwbxoyaM z9d1Bi8FF8EKmJ-BBZECu*mpGq*MHG>FO9rQ;&x}M#z;Tb@H?GC@pOfWeGNVJ=P(Cc zZIIIR^_cb{4E4i|_&Ujkn_P$36eI7rUyYlmN2Np~Vqeo&v;i|o%F=5tkeLHXA-G8l z(OQ)ET~pq_;jyx9nmcMM^{CGK>py%<2Yx<%|22p&`N-2-Gk4a(h)lkp?MmKXH%(Hy zCHZ%G^o!JyuRV=DNm?P6{EC;`b^!qqpi0XbuiQzs_b7B|{aKD=7VZ)r=h0u~eUgId&5BH@! z?&tPB%$*;~znA>SQoHEad4&2rtr6-S?3-usb1QpL^kvj262uI*E7ZK7O~<8H|I>&4 z|L_?vt+-;jnKIQfc%8{|WLULitNp6wg#W~3-!rw7CzKDjDCv#!-KSY{)RC1*rjmV< z%M{z&Zgr}_L_t55~qh2*HYar{# zxv!3k=(qeaUiy3@){@3GNbg1S;zXIlIrgX@M#;{LmyPs39YDT(trN^TNHI#QW&gqO z4Kk7(--BMvp_*%u-kf#dApH_J>!`AsJXmO8GSRzn! z)L;!W*s0fyCGT;H3Qhkq&w8^4ZxTG|lgxdIXXNTEHO7&znB_t3#Tw3(SA^oyE8aGx~r;a30_Yw$oR}$*333V@$JJ0uxJMJHFe>kJ3Kq*c3-fOM-&iPE# z3Fqgk=rE)$eeR`nIKg>Df6hkq!tb-0zw+}vCsO|^9|Mnv(MYSr=L_$lt<*6dpVpxU zzyCi8^gfr=p;l>f8OJc65lBX?&dA;v_WD&|-nSmLmYW82n?ZKYegpRWHlXP_BT6Y! z&~i7qizf}3`G~zwBMtDsZ$yEI0S%jx={SWQ)y2pKh@vlQtGV**VC$hT|w_8?OBN z9#%YR%2@~3-M##N>e-xSSEuLs6aA3h?Gtftvc7I{J)$7 zjPjIt7qZh6yrc`WLUEjXzU^E`+E*i2e!Nl=;+fl9rjm;5eC6#xH+k}Jec2l9DJQgn za;QW@dHXgt-#O`3KTwDAeu?}GM8uG=7)aE z zEKdrI1roSKf%OgZ#I2S?x^~DHPtM=tYUfEYFNZv1-aopF6L!7Im*f@&Vn3{bhbq58dfo>_DC)v++}x@Xxjj$F2wA&~E3PoaCN>^7Bbw(lbsw_#uhQG-#;@m}yGrKKKTkPF*ha6^BeEl|G6Ty$U%=0$l`~`Z z=}dg{&qVCA40;bU5J2zb$jTXb_L&_evD9-qn{l7ITBSYwyJP5kJZpw|12cZ~Kh+*& zL)VAY`JUTwmgoFQEA2Q$w!zP9cC5H*LtHts7m9GEbIA^U4)rUw9Xh2Qqt4LJSUd-# z$C4rUjQO)(Ir#RNU(<?cE+u{+zEp5dMKr1L*sQoL7?e5<6A_i8us zt>q)%_5L#Bi@!{o9w_mRJS6xYy}};8()U$>#EobmBMy?upjAo!R3GW!>LI=}d?Y57 zx#UUiQoBfiO!oAZja7ZcLe^?*M|x1;A|K{@%B6i?a;!MB#q<_-slYz>Qwof#l`qz; zJh?S0k360{c|omFJ+MHY^v##pGk>J^JbwOEz8rh4Krwxu1h^N-)Y1j==xUyf>+g&q z-ef&>qKD*?f>~0Bm`^!mvr571jlM|gIjfc{FgG?|;^>KNUx_@%GRYQdFkI1+7pTDo6Z_3RXmBi7L+`y7z4p_8 zm`ML3d)gPz2}j#G8r0gXK}?GXJP4&0xGW4u$AshiIt^~E4#$kb&Od^ATV|QPsI&6S{zk)|vO?5osT+7*VwQFry$fadv8U`( zQ|YmgxWvQtPUHmGf5KXXjLA zOiky#lS{_qznM7B@7et?wV`~@s{T;pJw-O!olK~2u?N1k8R1UszgWfZ$6uSwHN$_G z4L9qP1$NCwz8v+fs?7cd*%7;g8S+x}FlssDx=($D8glS#8%ExwZ`fo*iIbdvWiao} z`=$C*cD;YGV{cFnoJ{09PPE~3v>jK-MR}6Xx#o82>by^jWY{qHBsIwoHdt!g(U^M6 z_x-$=`L%(<8SE3ysNO$+T4OCCF7@Ep{|D6wUD?mWZJhRw{Q zF)LN;`F>ecja-uz?78Bed{U!CncOBtV#(1M%=utypH$IUlVwO5qr47grY@Otx@(D2 zu1>Oi3m}WJOrjW=b-YCOw_mvg2`y!mdq|R>O_i8(*B9C;%!2k*BIZ4{0~OhdJIK<` z_d%U}&W0Yahmze3Pk6p*)Lx0nhm~+y#xry(bF^oenboLJ`Kk(?Dv+r(%nwhl`r^<= zC02A|mZl3kKDRR87pOv#54)(_G4pjtiGJ1Sot(tH~3A;Ov5#g9DCj@KdbP85pw;8~`U4l$lOyeP!k zRY)|_$${@QpL@LK6&+_0n^Njqwb`58gemeA8z`bP&9eKX< zkWw%Y9(_5#=oQ*^--1pHxySrq zLA5w~8)N8?9Av?+a#l<}VZo}m79>);nzYM;m0hgx&~e{M%^~Z#1snGMKR@Fza<@yZ z36Qlr{N!VyK$*3+k$fAi zvWmXJ!YE)#iLa`iaJ z-|&<7eGB&3f#MX{Sb~^a2;JFO-iHT> zn~O@C_ap;x5j`M{%vc%BpNHDKDbF{f)Owo$Mnw;yFV&Ib2(_xepzq$A)$p z=s$?uuM3&*pw|AgtC<{xOcWZ!jLJ4U4#t0gzGM!%3?%!@jqBAqA6bx7UtB->NKG)PEu@&~D-7Ju)DlJnSqG}#aO70e6AF$W#W zKFkU_Xn3aX|D9*w+4*=*NBW1 z>e(}_cs?W>HQtgZ`;|SJ8a}H+$-2s5kSJC_6&928zsj@9Q zRjf(L;;v7YzmX}@mHx%@lbElhrvJJP*R5yls~GK%+dJs@Y)>zvf_eJN)CcItSp1P1 z!6A0%oHMe|)rcw6>BVTtUgf|P%op|$WpQ@Uls{82pS>IC>uznu*hTcCggdDxlKs`2 zy~=88mi6XS&om~Z}B)RC4BH9eUC=X74*%}KVzFp76R9~0Gadzu;A`eX0G}E4Cd>zmip|bB?`4ab>qfoQ)R+! zqb#O=HKQnVzB$Zw#2ICGGe0=unV-EtpUgca28a6NV=wAf*-?1YDH`qm<(hwyj4SGk zE<>rQdZb`y33@%Pe2=U~{NB&kDv~*as@eD&OCP@73TOJ7@_&=L#r5)0HD1H}6l!12 zwqEhQ+G)1rVrxzy9lDGuYh)t1cK zPs|}k>hYv5dlTF<5i%+hp6BW7P9(3E-s+m%&$s7Vabj-{CRo_*{Lzj*>+SFv$@NU< zCz_58rS%4K5hDVmDf=WV-w%>u(ezYSD3B9F74RKImhLTzA%E>{+f^oRK!*v$5nz=DHeEOISg!FvyUfa|V}hn8|}+4`pB`e)6?x z%KiN3mF$^5%U`cE%2_S0(FkcHWn) z$Q1TZ*HBK8aqVL6vzSK&PBe`q?~Yw`^VuO4xyL&CUU)96F)bbux%8XH zbA6{)kyv2Hg1*dpEvJ8w=lm%HayXyh+TPucDkbP0;2GxNDSuhEzmb?M9`ZSd+{!gU zVj4^DPrL%>emdc*8$I|F6&O*{8P(`RwN}<(Tcid)!^2UwcqIPat;O}b)NuH^1U`vH z<5l#Abf;D`HxA`$==olm;Y8-p9=O{^-AQ)@VDiKVBp6d8mSjS|e+^?+<84)ye-c0gY3 zKqV&d+33HC8Tx+YMa-nXdz}t9j_6?KUfuSd>%|}=)cz?LzSD?7Cz%PN)*9c+2>VO& z2iIEBEQEbEMXcEQgnQ&^*?3N--r)=EQ;r}9@u)%_m_jb%5rw+NQ?8#EIs2@zPr4;1 z$(L(9e`Oe@{Apht-l{~ozRU^GN7%E13a_U4;Y%SMylgsl?dTA9oZiYD9dw8IoDOAI z&nou9o#jmOh7nz<`v$9+W#Y4W0iQv|>0|u&Dt&v;$w}w_dc}6~^|BRe=gsuw)5my< zGv3ksdGI1dMv%Gxl^l>h9m)QSPLXT$S!NChK%cVoFFy9ghu>VgnyWBzl`lGZGRxIf zhXcR(njFyKrAddRCDg%dr6Po0#_PE}YrNzQ!L{>4`c^}%$7`bryxdhJAJ7Iy8IM?7!NIk#V)j5o@!I{W4PkyL56%@2<> zO8C%c>31jq8`k?{vx9R3u2;{!Vz6jt6m~X^!4mF0s<(=Px)5jXZd|*leLJY1H{!YG zKORTVDCPmUhN@Rmvz}-{=~(tS`dE?Tt5AQ`E7UzWyL4TkP%q>D<7X0imU9f^5wu^P zk>4beEKl6XI_A&wG{+BqyU9to!VUp{KLoT?!8urkvi~rv@Gc6k=0!vIhU@!A9q)5` z3D?m}xyXoX)5!WMYNU6H8M7P%44fZM%VHPOTq}B0BVXxaWtSNL>*b^_NK>e{^x&+D zKbP!QsQYXoKZ!ZQEm!u*_|J**fY;6iW)Ej}OqOG_=wTi}~V0f0N>RERN~v(^<{_ z)}wB6x+XjC7li$f|E0wVa_(};NwmAkl|Zg1{^4lZlfL&s={Pyl1_eJJ!ToKI6=gId?{8Zsz*Qz?b>5`xi>^zEq}fXk{^K*7NC)n_|PfV?NUFa=v(d4?}*3 zSUi88fhu?2!#KcKJZn-%+(G@^v;lqVlRL(Jy645(a~1{qFv0>FJKRB!+O%Qaju-75Qa;p zSZaJcZ|<{^o#DdXbp;;XV~_TWI6O;ZKQ-86n@unO-8>1&3Bx-2zjQ8UoZw#FIm|~A zsi7X=^SpYESRAjJfd&0-SVX^7ZpI(^{-qc4O2y&>^|f9D$UPk6E^on5|w6CBTVzQed!T=XDc&zJA}VHaub#7?i}?7KoNHf^Ub zEX#)Pzq}~Si|9%ubu+0ZB)>71u%qcf2E)`qqIo)UOHUsi3PpN_BFCuT^l zo&n(O^~Qu;5smTG1=w#K6G>I@t? zZ^LqOC(D<~mjaJ)tfkLRj%J{tjoR#SSIMFd63Kn+(HF7!Iwk{|-}vw4+~8f~d>PB< zM#9oqc%I9^_BwWS^{69ty?C8$WS1E4Bkyq;Xi}N`p!2>GfB28Y_S7<)t4GcC8RXB} zvC>*sR#g8hXHvt^gV$~Q68!n8i>#aHA#0B~(VNCT>v4SF$I+*m#M#WMdh*Ud{vhw) z1DVXc9LwO@*3KMQU9l!R z6zWxJ)*#F+uP4=$MmFK^DVOXm; z1P{zWwNf_Z@ZUR}zVE)g9=e{|Kz3gS`gHh@=k6wR{uW5Nd0}w#j)U=31{x*vv zSC;~b{Lu^5ij#kO(~NIJ>e<$O8Rvcn^{fCw&KeU;v93)rqde<=A_aJ|^H+iN$^i3ad zkzRfUlA;d7>PNAdb07oHH!~NS;wh86A=*~ zL}|$V(bVOf?Uyj%DnFiZ+<`-G|K%R2H@oYw;T*Ydoh)eYPM+6+WGV5R`<2V|@r^TJ z7`4$m=N)LqT-`}>&35s8853&2Dqs54m{I&tZjWqytitBHI_3)K58~c(lBWZ+WA@02 z!OYvGMkB_FS^>4vsv{KYX)f&1*y@e*g}6VQmW!yV>D22M+%tYz())!-ka^Iz)PvMpYq2wpp2a})JR)rb-cU^zO9_l4l zY@f$HXnW2YzWR{s7fpN;^De3M2T;p67`IpaN~)l{&3RH~!L*JY_NzNtu;=3XWIYY?};OpO=`hs^2`m=s2@w+t{S@b4Fa;SfcqsXR76+C^?Uis(A2g*dRi|w-!X{-Qzc;_WMUqrnNPi6bnk%(p zr_y)wH&3yjIzLh3&eI21Ga71@0dJ~XFoZfn)ka2U!F@6E#XMZ_p{90~J~ir7Wtt?* z`KmscyC(|e1{h$f#`k?PyE9Jgk%#T60j-XP|J7t%UPxWPIJxosITye4MT-$pSl^cK z`wI(d^mE|&0QPTvWv7+rJS^w?zSGHqe+JR-c5{#H`bDA|mG7E$Fem!s^pRtk(R&O19S`27; zJPY%?E7X=6MsfM3L>~=%t>{y^H6#n)8!Oa{&L@fGy%PI*CbPDrU#uv7$MpZsPu?Rz zHGQz%MTc1GR;`!O7kN>kzWUQ3W4*{vTgncUk9=SLdp$=nYrAN-#8o5Lg7cO(2iebV z&qBFP}XY<&0M3zsm?-7G#mj znVGOhJeBM|`zH$dI}P~JfHRzS3U$mhdb(zi6*7qV>)vGl^ZBrr`K1@^i~l*E{K^~i zu#)=e)d+T?K%tHpWt66`d{LC=oie`c89$PRv|c6zAH!p7}h{^Ez+L`OgHC151`A$v}FQ@R-}w6U1^JEiAbAB?6idr>*&zk}F|V&`*gS%TD}ANe4!^Q-{+RkN968nip zU8{y*Q17&aDuvVgIBzpmS=K6T$IE7?4^QkI(qMqr)Um94df0`akZQ~Jnc`oqO=}eL z#uT+?cgVa0<ZPcC+SVQ&n`$eS(=*iE1WPbZvD+vTU)}kxmk3} z27c>J?-~?04fQMED$LqC-RF6c^zq$Zn)aUgVw(47uQ*jT%I0>7@`Rm7Jqo4BM}LEy zy`CsPwj0F3KEXpN3|)-{Zuy)P2_QJu&Q+ zF2C7V{V7=vv@%FmQ~tluD>=X@dm5yQsbrEQ3`vs2Hp%jgQE+l{hkh*J&bshf#hgtW?44x)T1!lu&ZLI^^SrV6t-ta&Fyt zDm$W$N)+wO{`Sf$oLxtjfH!lie4d}-v+sbPl3XZuqbsRFKl4TBPfF}o`{LYvB@89` zY(K5UW1i{9^Y17d${vrq%y!P=Oxjh4t`Rz<^IH4yD~b$oYDC|n(S*LlhwaJIxf_kT z-FW|AB8!JU#Us7B=I*4ww`nvoI?^Y;Lx-%_)U`L0F>Q^;_&YI3aPWHOvu|{R7)+Q< z?cKuX6g|FSBXoH5g!jOl82mk`L$Dj!kiOCIeZbBK-ZOqr=xOiBOf9eZliQgiO`tb= zz5#{3jF=H)K&jbAOf5!6LnksDnljT#c0|ty)MGN4$DL$kM;K?!Ey-}4$~pHeBPKD! zQM{HBu4XcaFVG{|jvmEjoK3%Ek3?PeYYc<~nLwFza0wroHAGGRz9^MeGMWY{9-#R-C`f`8u zD7=w9DaR}rwloV(66t4jq7SNzw+xNgV-f~(L-+d z`%2z#cQKr*CrhkK@jUE7t;tL5qo~DqttXkSJ*C1)ABp#@E0s_C%B{BaQdL(8X1L3V zRQj==`pBk-?9H{)w^&e5hGqLn)Gl}VSXL=JyLm~4a9o86sX|ugn86kT*zsxQ<>-BCS(OvWXG*ff!Mk#Fl`@MK~M9g$hAD_ z|4@OXSqiAu7f9>Q`I51m9>;u#N$i-Vkx^gc>{V{v-8x{@IfM@HO!4H}#X$EN^xF3hI> zU6WeLP%Yl1vA4QMIM&zEvbRjjjsXqE6(J{a7W1WQb_2C%|Hd3WUgVJrUrCSU)MHjZ zBxk5Ny^C?NSg|4w(>d?hRGqV5S3QQF(qmmmc1h3R?>RH?NncfLV?CB~?$GQTJ4Bkq zVaDwLyjkqs$Y6KXXzB|M^k}nz{YdNMV7||D*aR|h9>R%$mQW7!bP+a`tjAe=68}sm8;a3Sv0^^;5qc|H?Wx za6F8ij}~?`OtrJ;nC$nk2 z50FdL1Ebdj%EYHiNxWTCmX-67uH);;p_fK94K#!`pbFpn5wSw62l~K`C6Ck#&>(66gN-4oL`QQvl^ zuhB{m@<9bGYn%`;wtfiAz;d9zxJTgSq2 zX;L`wh-dg^)H_>~!MKjy(80VnYisdidj!TRG^kOX^F7{cTa{#Rz1INK!%^*#7DqPF zPt1EN^(1*K55n;;H9KV|etc6Tp5N8r{{NnBaY#5Bi@ec# z99Tvjc>#Y<9jPnt-<`YocXa1mYZQILQ}j4oo!-b-_8kJ)%eTZl2E!@O=Ba}R_VRoFP{`G~LR=Zg0rJ&c5_d$azoRjin zddi7kZ>5G;%Z~h}oYS?YKZ*Cy9=&#hzTp|R|M3sEZD$Q0T){u&d(RK2Tbx@J((L)ekWNE> znq0qTnkI z*|=-^oiCZDmkX<=p9pp{O&{$M@}x|Da9G8CY1`e>Os!rYF~t|ZmiG16YSXcOqtiBO zZkqnN**twl-OncNl+C8dDF;J3S7>h1RoyF%uO`a^za&YWoGPn!8RX#PBq_TtNlY#1 zQ{0~*#ix-~w32;jedrPCZCS*a2lX_Vj9Q)ST91gW&1U*9@OGD`221%FbcWhnm}yD}9b{mAJl_Gs7l2oZ)`YzJpo866{L|V1~t0hbA|5_+g9Y^EL|hV>+mk zxEEYWFXKZU8hOW{RCUfkgLRnQl=Ho@^g$LxVeCO>Tc+!f5v9ZGU1T*Dis2lXXYl4a zoaRi)dXe1jV)QN!kH)r}(U`Y03YG#L{ZY(cF4y5>4%uO^$>G0az^!2RM9*NB?_UG9 zIQaVrBMy!-;@B@E#+4vIk@wi~ zyi=!?BgxzkHgJeHSp>~XDlnY;!lbbZ$S^H@`h?@+33}c4Yf*C|y(%O4^KdV7;T3ti zd`_SBiN~{xtW$~vXirbx=J%UuQDsNrFe9RI2DF zOWp*@^kFL2+6Bt83kqCaKxSlJXWVE}2z9zSqa?2>oYvy8J`%luYY;&%hO$*8bgv?z zxspWy&?bGlDaB_2`_k|ktroklJ2M0Dk?Uw* z&Q#l&k#Ot`zWU~11^1e-Ds!K@CGt}T`QafW=zvmJDJwuWAZBJ}EA z&|&vu`c;xs5HgfZ+m`Gv;B)aXpPAn$q@d1J`Yq@InbSBMk={HH`|;=E*)*h~lRCbZ zliFFUP{+QcZ*MNO(x(o*TxFEzO_<-DwNLB=66D>+6lt(vpA2^Q$Bgg3C>Tr~f?km8 zZTv9yT>zHTYcZyx4l{pKS6su)@3KUIPtYu`O^>Mhf@=*=#Q$3rY1Vf&!&&iLa%+r7<6MkveQ=s z^gi^VE->K3Z6hMMCcNb{c`DhA8x1_8`(&eOC$h=5a8^;=Nj=S?P_NgsuaiE9u>+Z5 zR#8`fOF!&ldN8ah^3{Kz6n@P8Kpgu+W^k>p?}veZ{V<6?k2kgPoDF`sRVoInE5%@2 z{TN)X6T>`e3~o%1L3jFhZkvpl!}rYN3waE|WD#6W!RDIx(7n19vXUIK(e%#0wqW2Y zE1v9UA2&U)F4XpiQrC9xr%-#5ljg`smA~gxWLaveq*qRn1;?4!ZImphI;qf(np4dm zHOX^pz{Iy;%&36=f&*&KN{jHUKJoL9TDWX z(J$D5d;L?~v!}8r;h-KfGwI2n!M$;7a$#p@!btz%2DeO1{%oeNnLNgx}ph%q@9OVAG<82?Q>Q-0&_VN?;aepzm2FZ+#O8Iot z32o0R;MYol_He@Aw$AVm>=$=hh&MtO6=Ld*; zYgcKI87LuJ8cN-4FR9ltK%5Rc;mZVv#CtiT)kkMEpjWS&pEGJ+3`ayFnfq1^D$da0 zPbm8_m^EF+nS0B@ahUv@XEVM=gScKKj-_^ykco%C&3N4|6DP^8%w-mH%Xc%B3vy6U zEC-voRuu1NN5pNO<@4E(Sk*_4Uh|QG>x1Mbxt)Kls{kt%%Pd7l(VGmgDJ3*kZ^JTy%EiO7VnD`?S_u{o!oT-K5JeiH$`?y-D z?abFBwGp$d;ap3X>QSvJ*_9W`tU64e%5r8+$J3WTmwD2wHq;DaZjIjDgO_sf@}3<| zVPrzbr^>oVDdI+6#!hVVOva5KCOx(OrV)*)0W#9EvfBGvMsE~Pty>(=$oN^6> z>JjIchq;cn=If-OX0MEakD0yPeq2k-q+k)xKtoR$kxT!%d$kkN?J%1Z>e76jZm_$cYK2rOvM@#N`_o%ln7xieQ^ia# z!?buMUI(dQxXJ%jxHQ8BoyWfyki6ny8}Riz_Ynt!SD zXVcsGl=H3&T({I#*xa+Z?vj18$BN?IZ=7%Hqz)ZJZVRs?U#{zKxYn2L>!d#VIa#a+ z={>#4b(B9-s}4q4M|M(6oj;D=RwAOiKj*W4P{yd}Kc`1FTE|XevK0nJBhQVm%VHhQ z^F3^yV}v{R8{Ii`2wu&3Yd{J{^P0Zh&dRwjJ)WM~Sg&R$Wd9yy&2cm|LbQQQQ2RH*Hw^l#6D%_dVG$sKl;pj?C9h!RYw%ar)e5Iz05w- zml^o+o4O|R&a>EeT@Ug7hWcpFqb_>i#6!6CKiL+ zQ=g@ut2=pivt0`00{tveK6;EfpMltKZG6~C2vvS^%!oO`Ydfz0dj`8McZH>pRC z;rZY6WAf)LMLqXM8EQPQUFFo}T&eBEY;!idPq=PWiMQcl(Yo>`@voG=K;8Wj`()?v zSy#(`cZJzUmHbB@Um;I$QXFceXJAt`8=kImm$FR?V*$m_w(!Fh#)Wju(`u#b2% zwY6P5Z!&K%Z)g}E{bp}(@l324L}vd!Z@E;QJhjeYP+g40ITL+nVAiaOr)08Mx9H5C zuz2(Q)Py|5Z_HSnR*E$-SJH}vBWF-79>&stx7dc(PdKYNn=kLm(m%ML8fYgoO8VMx zt`+;cZvB-7^sx@##7Uzw)bF-hqy&D+b&w{WEP{rI*)K#5`M0m08bSshQ{TMa+FN$M$P@p{WK{6)ozN}=&6$CyF-0j0Coor;%wFbK zu~<~b4DIIk*fpS@d?(-V%#$z_s>Zcw6l-f zU)(no$X+e|bVXuOD1tflIrQ@;(eXx17GVB$e1(lhb;Me#V8o9v*Q|+S7(%5#Hi2`ErSSNRRKa2vwUg;Ue|p;(_8m zJXc=Fy0Uz_uoPe*;F_mg}H;`6XsP%KV3 zGO)_QUZ1w^vW?t^V)0?HD*NG+Yob=eags}HiyHpdoFw4%bT&n&xR3v9gfs1 zkiwkL9k0*Mvv>3l{vg+KjhEE+;GXN?Ww!OoM9h5XH&=WYRcVJ`7&n}eW0;%=vjjq zVEQ@($-O{1CwTBW@5BA=?_C*)3gs-Ss-N_vUvft|Em}nI-!;X|t_d4@>*~m~?+VU2 zH2BAj*P)H`fm77nJ9$Vgvf;;5+sL0lK5tX{$`jZ>w#8lS*O-k7WZ&F{Sd4qk><#bV zHOX#LznX$PNM2WsI9sg7=PGsl`E5L9qbgS}chw@jv>uDUvk$$r9lw_tWrY)cQum{9 zhv&;?n=RA}=%1RKBwUh=g52cVe_%1S-P~l%ZbRLYzOAO^ zj1s+&+DH-h8aFj!%>e45-yEoOB2iX)vpe#AG(v79qgw>ehw%<(fD`4z1r_cxk8%2K zGR8$&;6iO-gTo;AnI);_L$APM10pLh>rg_Ww(99)s-i+wRTL)AHo{xUK5ObDl?$iJ zS`YeVF&b2-V5r8&OX?5V@f>B;zhioUJN3ia-@3G$&neT6M~-XF=l zJoiJt`SsJM8l`1>AN=a9!~MqeC3WZAKAwBng?r@ZH1fg@%){lNP^eRSCCYK`Q><(0r8vUg zVQ2pQ%xuK=OOgxZ=(XePTv$u*0=45hJIFLoNS36H^o0!4VM{&cbt;lWM_=CBrz!HB zvx1r)QMk4u8E?O2!Dlo3J2vc*xB~jo>gzBk$%xRxWG}hVk69-{rZn?Lb?)iQj58vp zFZtXF4h&7&E&ly{aI#Sp>YicdWH?z&l@#iPA_n<;*@v?w`VH^${h~HqJDGjNFh~OP zyH}6QL%B9aJYP#6-)QT9oiN*Vs;Sw zXL%;jkOj7PJAEyUqVX}3Sz5l2pOgyqo}68xDyqaH?yrOS`hQtKZ^S1D)`#sCiSxmZ zkJQwb8{itlp5L;}X>vC6v$hgzzDMC+9<_Q6b@R96=xGvVO}HPNsaYI3#F;^3awmD6 z6ep{G+;k-ZUy;>aiZh1k7Cch$dgx=6o}h--jXcfjWE@c6@9?VteM_>Ji~h0#8)p~p zMhrh?A@@k3E=HeEZf_qPeM#RLIen#^$d~L(&4;s|TI2?%X6dkoGYjLCEbO3PZ<9S) zuJ=}9Ri|iFh&Lc`D*dYb`VI#AG{4a2+n>E0kGLltl7*N_4rG!$ndHpQl@HN)zJdO` zUs>2s|LM}mB*GBVeZze%63a%F;Cj8r1FoDRQC2K4N2 zfvPTjWcA2@bWvgSa-Mb0GaqHP;3+@8xln?5X;s+%G79axFei@!I{#}zSt0$$K_~j;dRw>5n1l-=!Z2W%9xqtB(g8N%nt*ub+VvuF=m`k?v{&#l{grw zLyKw#Wa_g}jJ`!(6lZ$%__|%=(gU;ikQKK+@%BQn1mDh94qY2`7%m;(}MxobW`m8M$TR3Iu?q0A|FqStJDxhRCVa2`fK=8ks`R9muFn*OUqDtWAlW$BsXd8-$n+lMbC zN&x-5$xY}18*0GB;QusVYMJAc&NU;W@pwLci$U~9@xCz5O_0(b z*#jOLg@)~nID5l_W+N2p!LGcIW_qKcL5HKO$zu(rAM2b0lMfkWYc6}wheadk4Y{|4 zt!P#Mf6rn6KYqp=mUX6ywKkaUeA$s!pkCE-SIdzGzy~ zrg!?TLW9%q1U@jO81A;b(`cosO5*_2$F&1Z-y}Bp%%jff(ZTgiWu^{KUtd2dWYCRq zCR4jEruwnGAIL@gGBQafJU=L(dl+OvcCsA)nkWyirpTs+336!TJ}Gcck~K})@x3lt zf*S0X)$}z#p1Vf^bIH;fW0aztOYdHmC`niM%CLyNQg%U-RKB}MUY+3gTaqMWrzA_* zd1?*RJYH5zl%Kl|VjXOda}AQjXU0CM#_Zy9FN1WCpaSo#AAMst$a@OXC}azTn3)&pD*&m@fk|wt@XuR&uA!@ zM&mm*p_WIZQAJCCxsU*E?%ya(8Bd-f*YvxiqHvL3SS>Xq zU9A`_YZQa=L&;Vc5zUSS<{iU1_tw+%C|qYak8WNq2LJNc%G2gi(`E0)U>&=obhy}& z8P+_qSeKDUynr+9$DHr1pf5a=p6E~P|7&HyMuib+oUg2%$LG)nBVKXdbDp#3JJhZm zTmu65@gAj8Q2qhu47p@Daz^xb2^rX25A~l7@R(*mXX-eMK<)(BhRwS;i}+x~l^I4X z9Zuh4X?6SL2#m~Yiu$e6UkbqV`JGWofN?8D-^dw-_|>swn9ev&NbQq*LwSm4I}kn1Qb z!hEe5*NI-ppINxZy~>?K%rQ5!;O!aS~zT3bC@_0yXvDI=B^*s+M`OaN-^mUg}HGRcexvtb9mvQS$Ul}sE zo}_jNU?-59l-$VvfXe|gj{OMJ)7-@rLC$>{cjl8C|uGW(Q6rVjfnf2dhcm`Y8ybgl%vD3GwX3cTE!FP~@SN~5Jt zxYwvait+QkBA7pAANAgH`7)xv6L$Y8peHj={1Wm-v&JDqiv5*)$MU5I&(rnn4jFcj zJrX53UtUuPqu7f(ZHN>5gz2v;>;$)Cxe_tL8I`*#@aCsOE^i9QYHBj?A8D~+l?J`n zhU3Q>`V76aX!ApZMu);MdVV+}cZK6KXVbF=hhq%SXzF4byxGDIK_B+hBLC)T5>B&%LFCphDj#kV}UW-HPz&OlIV?XpbYBK+w8-Fmv`6LeY>6eiKi}JvY?-cl)L+HkfHCwhI+Lf6O#jvPICMS4IZa_bPNXu^7@)^C ze$C_OWXvVRG4sOCrj2n}wOY@4I&*J@%}AT4$dlwDUs?Sm}2I&aKa zIx`ay;p_@oO&?YWGiBwO^*_g+ryTZgr1I;iM_ryyrVVwhfj#NZ>R=}4+YCEBSoN2Z zVc&$zxYC&jtz^b^&rBpNq3$#}6Q`-)JgvqVNzqJn>}bY;YBscWE40qYl zqZj!})JSfGk*B}Fh8|~aI9$?>#m9JVuSM2DU-E!AqKKy;sL9!gEZxrg8gQ9x&dDXIG!7%n( zhxth7I5!En*jP*sUzvZ`Uwj`1NQXu$DKtbWFVnoFprx18ozsx{1b0b$7$k>=QG0k$ zU0UVWWAB-}bR|P*(F~Q`Z|@@JsrBUGK_4k{xvmtM;wnz_>dD)C^`!mbda|*&mq;J_ z9KCsVc6f?1(noeI@f4%dM;cD@5Qk1B4{AE2REs=mb%@$fP^FKT?SySos{nE?f{72Ru&-4X-VvD;&} z!VGpNpkgaEGl1O;3@UaUrR*+dz)mE->wMnpy}p0I`vVt84h+NdJokO?z4i*~rpvwb zhh?lEl5_mAfc)N(oayao?~g6}1F-3U7Sk4KQM+v*4i3@c>pOpJi2n~8px5GdevaW> zYitk>G}0n#VgSbPX71OyAjA#{#IF@vbm70{RscSAXC~MSu61GoS>w2dUeOydBMiZt z$TMVLue|(Uz8rHj#zdeJ@f3%$Tn9@c{+Cl~oKIYE4?QiehT-Y{FeKHX-t;wjiQmHU zOh;~TyKu}L%v{W|5zvhxmbZraom|KLSCG3xET_%{dV~?XxzwJ%sCy$YsSJHr$)#*t zD+0wMIb$ORl(vjI>KPUs=UN!Eot&0Zskm1o6(OM(I6Y%_$Z&coM$kj-9`*Y9#BT0e zP;nsVtHd9dldrg^CMZbGPd*0M-5zpjJT6+$^$fMC?QHP5M8DD>e7>i0&bP$|-ziqy)=~?)!-hBCxgNOQ zIzF(XD3rb(oDD|RBo}Ep{YzblQ@*jG=}mrYr8i6wzjnq7zYgREb8S6P(65TT$5A%w zP}g(q>|_p055BG!*YgP*Iy|@GVhR3S>0BteRtwMC;PIx6*|NJwr_YH;I=S8{bKN<+pS9ST}#*GHoqgx zuf|U?Pc7FrDPl-(bJ3x4$tRlDN$x(Obn>w!wUaLwI3+JL9WoDibkRJmW!I!9lUMmD z4x!W8;oaL^t5ZF>akH8}@6%(=p?y}FI}h{i7}GC7(muyZhACcJwTcscKa(U6G05OS ziK3z=@LS_(xk-)QO!_(9I$)9w)eQ2hVXQdaG}1fOAc21wCGU$t3^{RfZ%4Gm)iFpY zJs$hV9+b)K%^E^xuek?B^Ezb<88V-bgV7+AE1tA1M@-p z)6m-`Ujyhbu<=gTt4aGn6F2jI@HOK%Q37rv*ex_FlZ|4xgFHD{4(P2 zJR{0ZWp86M!o^~O^DKVcpda^S>cf6A6W|^B9vLPe#)zlHPP({LmqyMek##~*6g!O)Q?AL;um)OdGkyY@r-yp5#n&|O>lFe{-rdrnLS4A{*{3# zYWCRdw`L7u{upb(T^-qbIZ%hPp7X%<)Txvr@6a@KlQ?YrU1(gik ze|U}$38v0rYYKjy;(oTD>%M$0B0rIXLHu_)*MIAOnHRO)U6wLyC?Z5HgT8x7@E{lI z6lpJ8IqTck$&OrE`f@K}PUp-LSny4O(PeoKybMB{z#!CXr^U-KE%{{34ffnlJwgO- z4x=}9GjbWTS>sF&$GNBUYI;sA{SS2$OXx$`Jq6#mhtB2xHpep;6|3bUNo-j1gtL@E z%oRIAew?d^So2-PEv$vy4EKyXb*?#1#m2haXW_vDZW19`Tl= z4qj5>iK{55Dy0!?kfb+u7*UIu_)l^y&ojGoN}(wG(UY+xXPAcq|L2pohu5fbPoCeb zNz1Olu==Ndgl^cf56T*?-(SkC~=_y4H$X=&ZEM(niS3eb(A9JS2XQynVTzqDo zmh+R|E36N1lmC&FrWQ||Qd}E)O3!qqDDBizubUl)k^^#MvmJK((NnWgv8)}d!2U=- zj9sFItpl}7*Xf1wJb-zSoZS=kC6LoiyHL9HE>>X zgxKLz<|@6(MDjL;rtqjjbC0tRlZA5^UwRLQ7h_~^qnsXhSW0e8kX^xv(xR_X5{Us{ z7)L+j|2P=&9vHGz4WAz>Og}=8_cjkA=#Ike57RhBC&iR9RDX$aX%XDJ=O3p8w7AMGn z8%BvsikF4&K6Ly|5!HYbQvOlt@Az(H__K^2?XD5j z7O7YL5Vx%CT^2^*&Ol}>Byo@4#QEmcaID`Nf&Jv5edO6S>JW8J<1EPZOo5rb z@~l^!iE46Da~;pqZ=B=)SG#v&9j|bcFEzd7Xd9lVEj=XjmW$lz<0wZ;70aN(3IwoU zJluzT#%I)GljFujuEJm8;)^9Bk+y=lie}Syj{qF zUy+It71>L0A6&G-La)6PEM^~bphO-*^T^kTrmwrR4KC~z{Je5ey&HA4KU+v*xVJnj zQpv0m_R^!2QcBlRU4V{D%s)b1ooa^3#8S^K#bn3#cH=9s8&@AhkVXgHwEBo zPihnPY)7zjIF_zpo+!`w`Q0L*CJqsJfIUwP`=jOb0IJChiB>%4|4^%Nl;>y`Gr`$| zRCmh7!!n!;A0gkpFExY3Zt|?Dmu&yrRs6{NoYt5=h|C)3`n8z4i4r&;Tr7G2eQlOM z9C`-vZ)dMLB8am_@(#*tajYN=qu;Ri+Z>KJsq7nn@GK=C!MHsY?G{}?M_!Xhw=9@= zfb;Pae2!Y@qE)S2Xrrjh3eDuocA9j~hkkh~G@qBzbJ)uyw`V6xJ^EJWKTeQ@-t_X_6eD4q z)!0#2jU;02p2K;zHuk{6vhJ8VmmKp6p`5Ale4newxaFbftO-TQ?09tENneqRMl|_q zz-u*i^2g~X&vT-SJ^AHBIlt$7dCxQc{2+cFsnFcwH9EpGBa-iDM^}Yr>2QUnkB32K zHcpgR)KUD?!64yXVkN%1QM^m2QS*=o`$IJ@g;Dz^?C0nM^PSv#Wf6O}DxoNHLDgP7sUp=h|*~(m(W51=r zLO+}#{=2`q1)Kk+-&q@#^q_CxmWRx5of{6_&=e@!+Tb|7sr=(yBt5^7uT&-s{ucHa z#4*E`G?bPj^X18QEjrc<$3>oT2+BbY^HtAwQ=qMvKMF5Vqq{MMIz9R`PHrj(cIQjV zZhw3U4ad;ZDcJtUirr!_6C;S(6aS8@_J8X3RR^tT?e8cqwF{+Yj34@Yhr?|J`wL=3 zE;;sM`A30uKK^(`o}iGI*SxhAE0;LQfVd*jt`5MM4LoCJr{MC@9D4jXh{|LKwVN;N ztT12!d3hD7tA(pf2r3Y_CjO{)in!ab3wXjhe8)6LX`#xO$~u2s{J0JGXIqf|h1k_0 zwUiGmkQ$f#5VR!>;V;Q=QrVFDjeNI@1v2@K9~8zgl-ZJkW4u0>u2G9XEx4ZghuDE( z7<-p|x0_aM$aR$IN6B~VOy1l-VHh@^xv?j6n8)5!irW@T{WL%HNejcpS{97EXT`fS zUefVLp=`1Q;4XP~?SCdSi;F&JHI(wFk^(_v>7Czzz6Gje%&KO?^Z*CR^7te6aqLeX zGsm`X3T!*Am~opt%9{CdGLU>LS7M2$lJRE%c}C^QKecC0PCj#@^AFRCZ8SGh)*07>kfTJAz^;>GM3_vq2wOpx;g9@*cq%#s>lLAfeChg-SJ0A0Sk{qB$F6Uo~R zO+gt2J@<1QW{xPsz}5rtrq0ne4e+C=U|-a5{_m(I4sixrF?|+x2DC zmI86!7(k9QpTme0G?-~cp4LsyZz+-i`~C2IAu}u z6F#4xaxi$EqjXGRcECk?WVdB6e2M(NSn6boU8UVn&a}uo8`LBmKIEO+X~p63Dk)Ws zzc(%bk$ag_+>AaI0n}b@Qp+7aZ*!*mVkh^3vU$n4nq@^jos)Q_{+3y3zQ{Wk1_#cE z{4SGs?Cm6PIg|LZ&liCfu50pnyFAN5P#u-5YfvQp>3ev;FboeDreHO%=e6Dra`1DJ zOlr?ertmP>meaS?9FoipA(pkCP2yFr+8L`keRcqOY>aq3???%0Tpju{KwZqR$X0P%2Noh~dfN}JFpW_O{WN4c))d9-G=t$eYdK|eWr2%265)`%fW&}SF9L! z!A(-Ae<{WK^|W0CR`I#gai7%sHD?}}g8pcJ*gY%E z^2F^jhERXw+e}^!{v|In1JI%;pR3LmJYH(WsM|*QKptOuUp@DK&dR4}pfziOT@HsN zk>`4ZiaL@^`l*qBWU0q9ko+d^no6t*(&5fY1G-PiK-?Yjk~SO?dkej_cLt*YvD)9~ zGvPl+q4~ZnN^W#xW+iiMm)&9>aYOQ--r(om}JH9j^ z3-7NNHNtJzC-D!R*~LFtT&p>P-wcZj+O>rnUI#Y1Wmf~_wLKUs6EB>Rw92V zjy$hpA@rs&Ag&MdtjUj?(mF;a2e{$FsSqd>tfh8mVA75v4DTE#gLW&?)tA?80c$>D zB_H^At-ELt|Hi8S`M%XYMqU_kf)Dc*nljYz%)G+9V2chrUm5`Nh7wr!eXK+;gkU#R zptgU^83R5{Brj=SF{YM}mHWqBQE^fT&i*oBR3QD!{=;F&IjQ_ciJMLIsD6=tXTcfx zR8))~H{ztjO!}Su2!=<0^2LfXuyz=0rvpa$o~|UnS%>kw{x>RT;rBnpa{4Don{i5H z#0F!^5+l~HW&KQkWd-U+_B?juEIF7Nea!9HM87BED<7Q=5`4fFxw;TsSWO=Q@(Tv&0bLdnL*V<_-9J|D7~EhQ8j59V6H5Kg03H?N zOp`cyK17LA+d`1@jd{&&Gti1WJCzIdF4^SR^y2&JORc3Bb+F{;J|G|H`Fv`n?gnG; zEFsMeXJP6wixB(NmuqX>@irsn{H-6LA<0J`M>R0 z*Pdn#+iC{+n+Gz`_6u{m1EZwO1to^n55Y3>=Bgjbz>Ryw$bL${$WKaCf2IH5^WTC# zi~(DV5iuuPRv%NM;I9675tTmt*V1vDA4A;|L|!$ZW(1$-a`bv2S)(P?o zml&mJwHtcw4@SEZMqE6ffioV=+$k3$8hX%qwx+k-A@Z!b-xjVcMt?Ou^6rwKs13$A z5Bh#`U)scdV@acU2|cGo@N*sZai5HxlnMLZ)SSJGmrFl5zxzi|Zw?by{>Z?H2gS(h z5hEG%nD6{y3El-#`@A3vYupu@SB;{$-rew}OE9Lok}uUR3%X0iX!s&d&JUpPVMWg8 z%Cm1=kb!^s^_$ey-S15=mF7Cm^Nc7lkoye#*7Eb?CA*_Lx(Bi!-^~8?B@9Iy|;%Q;4rjAw2&*YB3uJTG3mB7nVe)-3~CouRKTG0Lm-b{WN9Eo}`w@}j9N zb7Vddd##;37fwd1*uMm0Ux)!N!^w>bD@NO>SZVu>9JvE}lpRd`{1f?=-2eZZh5f(q z8AlyG*{R|9xQ@9mw)&*a+-)AY#kc*gykwudXR>^9mX-9WR;E(N`uUcmnbWFv+!kFk zSrO}uLYd!D5u7mFP{CH|yv-}z{D@wUi4Do; zCvL6UYmhKzKzq3wL}NC|raCc_#5r_HdNnF8$IG3;CZT7GgnA}Qh0HkS?Zir?W4sjj z()aQ?IjSq;Ww0_v()fJ3{)m&hwpjV1F^X$l@DqFd@M>3A)oa!^9es@#mTaP zhdJjl$@e<(Qr*cYFV4ryA&{$H+YK8lso?LchK)1nZ+Xm%5YCf%&J7(;55>lue~foS z<$EeDq&MT+5c(`CRZw%TJ$Z*3SGK4ybEFE__K~yL)*TL8__eqE*=24>oUFp~`YPP? zP+|U8H?(Z+&N-zTBRZ>bvomq&zACJ`s>DC%)tDtNXI^e9PgW9>K{p7HnW*iJ3!QqG#a zjp)ALhy&aoUxgTPi|hC75ze3Yo8TG348U0Ojn~r0q7}K1QPgxk<2wGyIrMN7{I2r* zJDO0pz6t+KU`}9bdcT(7dFf=tqA=!3ui}|%Pc5jCbCT7>-nSdE)gGciH&LWNuEXSqA%+k`)oA5 zm4%5n>D~CAKG>W+*W1SW>^aZIEA-aUF`uh+HqU`f9B)AX4TntJ9Y?-m{VW`zSHX;> z%&K}!oUJQsv3bm$f6Je(!mJj)P6h5$Ybww~IM_qlbaoa``jjl#!kbAc13el2U1ZNidj6BYHDH^QD6T7|SxdDfZBokhU{}do<0R82yGs2guJXL2 zQYsB8kp1KH<<3HKs-hJr+Qi)3ghKhzRe|N4eLlTN&XuPEmmL)-+kkw-@B(SS^pCVD zpysfQ0&)2YEUZ=_p0zlabXVZgUV7hwhxMFkI{XO01tb4GTg#fp zAFU$%(AnD$Z#@H0+szM4sM&hxOTN`R;@1ZH$hrHocVUhLd-heev>13^i;O$$NBS}= zSIz#l0(}=gYw>0=v89**jH>KUZFV5mc=+QbzxVh_Kg{-|r(skVlrZ+rw=_KLuV7wm}_(t9Y7ehnQWFg}qUjQt~!z9bxpe{l{& zt!r!I4R@%^SN9Ib5n>e`eCbUi8i1rrZdhDB)5u@=+#WMCvzm734;+zG$7E_0J zJQa0`kjXJI7^wk%G8rIiJt<%ydoTd?o71=Z3mh!~oT+4rgEWAC@jm$Ram7Wh?2 z#fHVnoTbq7@dY(#oJSnVO2GsE?xVGt+4PP63ZFT%F0|sYCwT_!Nq-K^Wlc$qXqi0J zNwrZg%o+Py8^+t)P@OZK?~(M2yF(AT4%Ca14={rK3FA|0|AvyI=wd@}eqZ5z`Z(s$ zt8sNM(l>BEzL;JT(d05{tyr8+4>`{4FW2YSb}_Gt|G)23&hkGHAKc<5am~~+d9}N| zCFWJKYco;Rc9#kM%z4=8EHlqJi}hz4S$kY9mzr^&wb5QoL!F5GxXZ+O&1La*2f26G zNdiZbL!9Cw-I6^d#6Ydqs-Jam*w4Dr1Di)N#l%T;wEP)O&;T{ zLbYrf>>{_Gs3knJxf~-0cog$PGTn+~1bK#P@)UzN+F|6)Vq$dE6`m}VM>~ltE~X|i zzF52l*r5sYJx+L#`$#Ti_?SO(rH&o$mgSuP5xI}Yi{;NRu2pg*-qDlsOrs+HtqSCB zDU`&?3hdfU%;>BFowM!mY=8pond6>FTyEOBVlj_UATiM&cTV|X(IkIl#B<$zBR;^j z;a5+KzzO8^9tgl=YL9DiP5AcnhkC6a_SFkO&{JPrObI~mj?BNAOATpc0R4ahP$@%; zUeN)l`N<#ks**4A(H}{-$RYNir-?u3H&*7~O!mjDk>nI}239`OA0v8jojQog@4``%xbW;e&P6{GSKJVe ziR41IzsYP5PyU{#%(fsddgK>zh7PUK(Qtj6*(W=T9v*}k<=V# zS}^Lk1*cA0@W8^1_GD(ey(j0lKfPHhlb^Vg++p%hHhf6IxrWqqt{~3UGzA-PTc8gi z$MG@O+-3_V5Wi@CGX-BcQ=3DLe_#N889S$<{aNa)dvcui?W_q(a-6?r=_(iiWuc6OP=ila#BY(^x2N!g5st}%Jd7fo1|7@JkjFo z>W4OON|1xE=$W|gu#8@2lCgQL<-1ewbw5EI#>Pn=`39B8M$4LR2D!GI`jqwtc}RWC z;cxNMqKQG$dld1$& z@|eEr&E1URH`|twVRUzgrhs2-qC)9nH69z3#8lm}Y>XPqB9+)OQH63<>G^b7 zg&VtA|F57nM$0@1)`w5Y=h#-BoW@bq-5#eW%N`Hr8IZRSsKaXJ25cwCWS4^aMe;kQ z@xR|_^jLRYhmgj4^uHgBP8XOVKu)8527Bi%^i!OzM+m=f3+uf#{NBI!lGmsW1swF~ zJV6I_0B2mbU_@*qw}7GI;rf>e^>>r!INpf;HI2ALEKlLg8nPm1 zZLA%Cw>LsJn>sdfR+5Q*C@W;)W-ZR&KwZnXOq`2hwx(}3UX$ZEH=g{K<jL$eeGIwcoM zw?V~nvb+Mly%accR*S=mK%@=T!ciHBTD(>}SnG|N9)Z%Ec_z$?_+JgSk9>^&ZajnP zrXqA#Dt>XVe_bsVr-<`^I%q-jZ}hC>K6sk-%gU=(^evqSFZvb8y`++}d{_Tf9eFK1dT1@>$ z50cyAc-gQVaBE;M%QJEU10~r`+k2Hjmdxs1pchy&FyKj5D7X8_zpC!X1@LtMQ8a=Hp4^4^9llgGh28esdpX zkKL6y)7eepVPpTfD2h3d{-*!s{=7Mz#W`yhUe~2R5&O-TEi>_ZDzgB_DKy@->@;bG z)VLFe&7Yvq98c#Ao#)G%>n4dU881g_8>LezlSD)%NCmSBE58yKdPDtUDK*w`kN>8*R1`|4rN8#1VMXFvS-J^dL^nJ|g_m;?P}ryOJ6 z{n0Fxuat!!_T1ANDKw*rqdS$g)6C{fzw#=Drud6O(|BUMn7+hIeVa*!li%-2eC2oB zqoS_pj%nNIyHKh*`z$qj>D8F>om$LnJ^KD3zu=P&F(r9@CXv6V)nn*c@<5IdKaDe? zXq5@;29Tq^llb~ka#DDG7Nk%=o}UTZ9OfZxra!KooyNB(uM08x4(ZgtGjlqTcz(<6 zhh<28a%G71e53Dj`Fr#yn|Vya$lY1Zv($rGPbHSC@E5U@o|oORF^4|Ft$9AR=UHS= z?*30b)_&9D=`x-ht~@Wu2Psq~;FgaG!#bJJ=mYr;R%T%LW-nimiQTWWP-Qc-p2)js zM$Scb-mgKY6q*;rP~&*d(mTb7$J%%q*uX>&R+IeMMt=Dqg!Kzb#2jQvl`aGqHk zZ|IA-(w+X4dR+D5tfN#Y5*(>vk09Q1i2Q#I^PGuUqm5tCdS*W;yXB=@6H8IM8Q~BJOd0qIqfr-x#{R!5# za}(-z=zoL$wX?Kn$v(dq=Z;BrBhawzcJy0BA6;uWXpbG$ha(I@FU_}Cu}HQXDYQR~Qg z`S_I)&^%|~Q;EG%TsUl#EHDxaNXuluVz59Rk%~N|U`>B!7caD-2G7*1{cu*(@Nk1c{Z0DX_1%B{EZ}f9mh~R_nchVFP!Orq*r7|))!@|;rN^U5T30I)>20? z(1JDW>25#dz4GDgI^2SdPpL~||5MgG7Zsv-ZalPM=YAW~chSGc+gXw!CJxe18>2o=_3*QX_u_^NVxT*cuax*8@W_ zn`hU~mZ8Y!xslW`6qQ0v=#$0Tcr!ihICuMZrU|PO`H@EbcM7r4;w-F7roV6mH9Uq) zEO?;MSPyak>uaY;;an%0GsYdW6q=AigR}`sko|@1!Dhru7pHhRev7lyInD8Xni^y4 zy5sE~cWkcVj$FPU9p_kA)`p^Ky-?;ogra&w^5LJ+^MmKtn`q*{tnK4IG2=Oby+W=L zA1{+%`H@*xpE-ALN`Ci7`qjRr&u~YDW^sS!UTsupN*<>_>{^B9{b0_ynC-l3xlvqV z$gsD{L*J4f6xaZO6?~% zfpev1bD0BBM~wuYU+X#FQne(9@iM)NI7c>ZqL%F#dr6)b?}o&aXHP$0-YfTA%uISo z{n+0;<4e#FvG;vEUd6d!KW2mLvT!ahi})1JhCI%t`JOuRxzX`nEx1L05eJhLEip*_ z21n$@TcgZ>mmoim)4Rv0!n!YN_;SutEmw_=JX4!K<2gS)6wj9H5xXW7ia0&$Gzvxi zGvwr_QX9}H9&2mH5XLM=a0nfOVUr@jyg7;q23o1n!(+9 zZbd0H0rZbNPCv{4+lOuM+E_mJ`6H%w2It`V(i_)2=`o&i2RcxyhM7;7;W9d7K{=YW^P=>XAzwariIM#}wl`isv zSa|ILT3oA3Zv3efjJ-`hS}8|4M}FCmTtB#!BVN2O1=G7&vDeZ}%6Fq*z-oWgSkB-3 zI2pq_Qu}?=Ri?iFDP0>AyY5B47|%od3dBV1n@IYFKk{L{KT6c0&ex8(?F1Xbt~$%R z%6$Li#xHKlv*S<-7W8Fb^R|)nI>@|WfBNoqW!>L{KFGv}yvWD#X8!5#e#~siB^F-N z!WrVGxR!hv9W-GXC==y!yaR8u%B8H~EYk=7zy32`v)$=f2eUh2ai)WS7)7bUo-QC)Av)Bs1stA#-WsQ_yFq73(S~ zrDXr#G9=v}p{MyA_DVtW8DfF0c%Av&x_E05dvzQ3RJ9=EfE5jgH4sO>{$5w+L{Fsu z^cv=sucZcK3Ui7E(cj`+0M^=v;n$uNbXKvxim?}6twO1$_eWTG7`Ah+5OT!|@0ZTf z;Y@+(ID_%{!+FPM`U&c+n0?npl9v3DMbG`PttD#%)=Fss8$vkt2tFF?>Kc zdQY_A>Nxs@c2&u^!cx zXIBer8=kM1oMdS5A6cGFUhoO>VZ+H6K0+Sxy1G)kOTL&^24Mf)FvR#;Q1U$UreC_s z?p5?RY|XsvN8$K5g*A=06*aaxib>Btwi)jWd+6>JSX&&=!O5FW5_h{$`WyU^et8=% zlw-YEgV%YtvwW%bhrS5DSotap>AzC2G?aN$L!BichBeP?=2MRf!}=A;xUI6{KIeF) ztp)P;H9s67rsG(XdDFs-t8I-%N593^6WA{|p|9%)GprHhlV&!Pbf-c&#`k%sCOtOz zcTE{+MM_Oa$?>NZ|l;nZ6#&As!*zmXr7z6ryo(dFT(xD{P#CFSj@k%4i~|FBFQ)ZRV;eh;5CvpfunAk4of0-})taspOR}p_j=Pd9N`G7iN{4Mxgb=cKVjye{|0<%9>Y$JbGlY*+m-Gd+U`Po-2 zeM`~XfwlkF#(Yl9IcUw{*z3apOfeW}Wvw;#+^3$mj73}^Wopun<{%$WPd8OSCJnnl=9s!TK4^`uaK z*Y`(-F5%dtOu?wSoCS<*BG#S-(wFnjLOv&3JX7&*a}H))s4x2aMe@%mE&ARKhpLMO zJFPibUp-cqhLG>pU5^+Yvuw&zZ%y9fla?mw74M3^L!2HZg(~9K z7xkDCYD66^{SY+@jh$<>+$OK^>kN1pNB^~>#h5)QR?dYIpBSSD(hUf+ke}5< zp?Q-YBhQFce#IrYo=9v9rEugER2$6JzX(CsmDsC3HxtkP(#oB?qM%MlECIp_39mvqIq5%Ydi*GLaIa&`hOYSipHVETE^t zg-i6U3m^xh8GDDj(Ng)F5=kd@*!tZ>4heHC8rkch0H7iPD$m3f;U%#Dp^v`l6->^FQaW&$k6tTRO3FODE zW5y?OFxBv4`ew(<%rz={XX~)vYQSIYCtfO;|LYPb#fM!v_h5!;Z~BM+PDimn^Mcz% zi_cE-@5qrUMXc|ynVIOVQfQjQ#K_dEZV0-fL*QWMhCWZnSl-8r4dO&QN)7)f%y;g{ zzn8e%@Poyebbxu~!&KNDt4HeqBNC3%_cNs!iOOh6;mqf34?gF^jF_-D17FzJ{6${p zg7M7Dj^Z4KzU&{*W@6hD@@?tGv3<5H=DL%QbB=zXnaox1RE#Sxd`I2fOB)XZ?JZ+LcXEXXeIVM2tl7nBQ|qAcA8Cp&rZ?eI@S%*`}MHvV?s;)nbc2GADqR!>Agx^Nz>t@miX5N?kA4L=zT9%1|Lvj z%;6CHv%v@tuHOT#$ZsvfbyPt#Z-u$c8#j3l~~m)bJ~mLCSxZJ&wfb&Bb;A0w|DsbD29 zTUTU20B1OE?G>6>-rq~zlz4PC1QU22jHj3@b4H=5Habp*9VQQv^RK@T7;&x==RIS{ zBW`69!*lYuRtMuwS0k=R(obz^F)^z+F|Jplc%csSi@ilOm}mTlx&KikcI zxB_Qkt(l=iesLf2aLb-n!o7hGn?D+0c*W=3iM^#)yo@}eM6>dI{;Lx+D?xpk#d614TT-RfUN7GMDiNs_bnm#uo zj67m@?w=D3)MYnu!(Zog^x!n0jY~F;9_Mq_I!-EushD}8!}JKg|F@aA^}HB^ro~8a zs}h~u^mtZ=yhZk(o&ognd|{Fh`ZEql=gd#RY@Q_<@FB04?V3Z7R-4?pgbix#!H2Nv@~1n@=u^NXks9m0WFQzIpcE3dtAUZkV5aE|u)q zq>1@P?{FFqGL*g$>+?Z2WE4Fipd4Gf=(;R`+ZCeYS@`*dHge0DqV|{o9|-9oqnY! z9vWrUwHOIl&U@J;R>p@K1)O2mq;JkY z=-->M!yu2Inxu7SgG?iT-;K{iwZ$gc{fzQ4){o7OY2fBRy`s)uB6| zq4lggMmw?gn8cr(9Ezi?6B4-xRjy23stY}J^62Tv+GjHN|2y?~25bt!!w`BMXvs@o z#%$}k{GKFosw4DxvY9x`zd9V?oV!hRYDn)8=lIJ6`|n0f_T}t?^XKwqO{g&0gmauN zk18^u%^oA}uQp=EN6t8Am@xLV36-Oa7+J=IWyI2I8;mG?ZA7zF?&)8R@V>&?bS>ih zZU4)VFd=|AyX`rD$0K6y+!yZdpyy*t`Yc-vnDUKTAe`ekZa2X^hg{002?*&$Uy2D? zu;kHa`yb*e#GHJ-@N5}O{^5D@3>BQAaBbcr9%LFyZ)(n#pCx9X`-cUXa<(Q3D-h(?Yduo9`?u-ZzuCPu0@qVl#Pm-AyiccalYJ zjxyzKQ;DA1OzJ#pCVkVJ%2;~J4cw)a#0qYbe853ErMpQ4xr)_Cc}ViyMpEYledy@f zKCuzAmFUwr`jLxFt*I8-&{95g_FFJhDHZ71U;P1pzpsijh60(wyuiXog>vUyp$u7C zD9(oq1QcLSPJvI< zUbU-Zhq2}W44F=^_TK^6`jh?$d;IAuq{VK>KwN$22a18QbPB!Q$iY(g^~dr%zSu;~ z+_##6aJflOcrWG$4C5@+jkwWaE$m~M8+}ZR9uET0u_b$+x4t+yo3H0X{ClYuuE_zY z8p14&7C~sJ;J=$Q=i#S6&l4>*O5lEXD2G8sC z0}3Xt{hRvRb@X~5URI$ZXT}=lQ&)+=+}-3nZVE>d`^Lx<#N>TAYyX>l@xWAMrdhCk zJ~g!isE;de!PFxbTv|Y^g#A$5Vqy`TV>Ae1wnA_!dNpC@263qc*Xco^qR$ZL8+Pq2 z=w2-q7oS+ryL>9<*yvI4ff~80#IHVB&~Oi5E1NTj4Dzh#A9w2}Ib5YvF@Ja}CT+Fg zb!&Rx7%kK++c3X}4M|IwxluM3AL57=jIp6!Q!7kesngA-*360j?;}0>Ij?v?tS+q` zb;HCUzH+YeVG^;3GW1}&YQ^W7tlnFy>H_Ixrjb*Lo)l+NiUe` za?Xm9Kbe(#(1!cH$YHFRixqqyNyPjwwsn$2J)C7OeWd)!Jv`B&g}f7IS$5b(PM3C; zzIn~$VUm;F)OyHZVi#Smx=1DOX41M0y-jo6WE1@x&o)=eIX`++^m3B9TyJl7GW#>m zN&akblLPnEa&MbbY(w2-<3N?TOi)S8V3jmK;zB)zr(`fU%zvt@crQ>%Qd~9X8hHyfDBH>BEbq_fRboZWBwSzV)m=0Mi1s*hH=3rq9G(hBI?wp_Vy0S_~EX zf9&IjgBIS~{4t#C?Pc`n;J#H zZ9RRi+LNcanmKhT%okh1JZa+2r%RCg*gXQ(Q;9uY41@U&v6{#9fNV zmIaoN^fA>iJFW_I8yfO+5q(ZpSx};t1*N!lQVZw<#r3qzkKEy8VrNCEs5hJ(W3G>Z zlZchJv!Ki0DR5YALH)g{C=q3Wdw*uue6wKN8@^6-D!d? zIoBjT9Os;8e#@j(lrvj#YBO=6w^rDkbMZQWv&cU-^6iOf4PlPwS#o{CIgdO-9*L6t zk=x8{iy`hk%8El-Jn$PDwI#VMWa(^qwfe3hTnE-&8PF1>Bi%NY^ox7%x* z6AH%qc)WbragSXS^Nh?-oq8q2`HZ;|Exn(|$il`k;@2r&X16g)9b=62YGaT}%$)9) z$T@$oL3*-(>Z^;BJ`G|dwca7|R7c6Fs|Kl1+9Y?{Qp*yZD7&$i z>$y{f7xW}qvPp&2iE2z&yJK=3`G(Zm?fsYiX=61Gu2kXc-^`7srlp&j^P2W*w2E}c zNcIzl`co@bxj9;XRw4V63ND=KSS>1SnWl!raL#oy$SWySvR7s%z(*x+^`y3@ggf@n zcE|2jD%AH^Bc(DmFr`EB@EzxLgUCnxOOMDhp~zL~;axWb+T$T;@rT-$F#4mg-#Iaq z{DyuZ zD)s0?o!>;(qyr8y&mxi-NCx{=_WBc9la`yJN2OBn7{)s9;Cmx%>Gb>GMhzr6Cc|0t zJwC>{+-=TQEk=yqKrI>Zt6#myW6U$4BmeDkjed@snT1h>wIA!eQ1UKzzoCY&hY42( z^5Z2l*zOxK^D@01`wl;(_<-_yP#d#h{{^(pkiqVG%hZyDGYlZotM zoWFgf2hG+D%wSD;#GZZGnoKy`i1U>ox3Os*UplU!`iR? zJaQHvXTqa;7TRy1r_EyeS+&c;(eK26`1$U9dZCfy)QdHsmytbj9%r%qzSy=u~8?jnqJ z?SR2<5avC0pU?X~f57_#AJpJ6m9!K{7;~5>tx=Fe9UNYZXEwee-;&i}M za?5*2z+#(3oMvAmg=fig1yU<1QD(dy^{zruAi*d(HxzcS=yN!OvC!uryu86$I%5>q zxL99xon`qBed zq??+^;Ter(MpQGoXZDh(6TGE4y_vEeE72w04l5OQ_-CI2mmJCN#VN4oWiZx$4McnH z^^<0V;Gdejwu8Y~uZ+cvpWKg2#vss#T28IWrwQXE#wn?dcs-%iXnf55_9k_%ZgQp~ zHXjb$-}cmchwsbY!AKqFw`9^<2Q`&p>!_;?FPU-JSDM_=%J)US;?Prxdi9j>twX)P z=?c8|Ag{NJ@upuW=9oe;`B?};9|q%wu|HnC3&C%54E>{HPSVE63*(Y;pip7cwj|73%AsCSN<(haDe^fDifBb&?9ah@_|mPXoF z^^&sZn@SGjfM%BzP){KbGDv~QTMCSr%d_3SB&shA!uHT0e6tHgRdPHTt3wgS>-lzr zj6-%T()+}q&-WN|O)+@4gZkg=EwJ>naMr+rBm62sCd6bjs;#FrZBuC>Wm-r!8a ztPu18=M#1ZA@42cid;gm{v?0*g=mbO!dU^H#g}-0?p=vSi!ckqQW#q@HnbZ-AJaM1 zKVVFHj{KtSCpp+&+nFMZ<4jT*c0m4kM-SogT1<`d#87f6`NPy0mEnnP z5gN``EyB|R&hCck(e9=mRaQmfq(P6G>#2jd)QAbsjrdqdJ=$HYX>OpG!GIhrS(63# z{W+K&mkrZR&iPf!!DF(NLwQYuKafcYQ|fM#$5>oVsq1>0T1|!VvVuIwIC2-24jmBh zEe7V5T8yp4bA{J(x~T^9mU!XGN>3EoQ|piS<;IOj=;yH)a$1jq0M-~jaAxtk2{reU zt88h)-(teDc}9f(q}JCp?s>`_?AgrxdTTbKUuR=*Tcz&u1hODx9(r|F{^yn1=o7WT zcs_rjCcxQt337RKvh1pzB15~R$o6-h*gS(8Qm@E4T-BiYA}zwpdSZjG9^v$qXx&2( z*9m&G9KHw{^XZSt>lmHF&n$y_h^MI2IN1o(8=fT*S$H>!dA%34n>KPUubzXcm9o+Q z0==ZjIehbD4~X@(J*+A2??*ib&Z$ovmn6G4a-LyYlC&R~B4vCNWPiLGsyG!CBQ@m9 zHF!Op_bHVgup{)CwS~MVYcvx!M_|Sw@`JM?K|&W>Ss(v!!Gr;Hvg#5ogkNTCY&6PiayiF$TWs>K6@w`kZFmscf3(*)uM;! z)?|5I$0V+uGORwBcS8;DES$k zsG5uwe2)IAU__XU5vwQWpi3t8$1Y~W$j`282G74q)VtbCZN}{i-5k9_H|w!NclJHK zc*5xa6xmn?P4g1_1|Bj>p^>Sj8q0taYALshXG3E<^sS&o?S(uyZjyg@Q&N{U7-ii< z(Bo1d?$`yR!Kz@?R)%m6kh*%KV=!$@45DhsV8#J@{pC<+cuWR7>yfAKZ^qY?^e{d} z?b`Ylgr20Ho>M+jr{`m=*$TB|KEjzxzFnf0q*fY9FX1k+={{2RsYaIlY$dieb|`mN ziCM=uClG9h;tqCjGBWRC4s^>D0%zt!E>o#x)IJzDFNUI8{aEzC2;Cm2vm=#5qT&GL)=2pbvS3i z9tGjnr5H536ph<=c&=CAoWd`1mdvG2f23a6AG{xBGw_jTeD!4N$-9tm{KJaQF8S2+ z&PQ458tprqk6yd;G3b`JB=2;Q119AlZ zogKD44#ted!Dv)S_Wkc*L#1u~(Ts<& z^ml%nj^N2=>f@NPowESTujk`5&oTdZWb$WP;mEu`(cVq8E!0xM%T>;CCbxO6x4i47 zm6OwKve28J1aXD(d!zz)mhg;kt-z_-!HD}DjLKvgOI`@Z?1Ug{jf5bVx#Eqn)aoC= zdC_z1^E$GI@{Bx17WFiXEYz5w{xb8m5WN{)3+Ovtp6AvA&Ph(>JO_0VO+I5!v@+U`-rQ%r?5u~T4kO{H&$@I!F(PNe8Mmpo;MMku3PmZy4 z4zASB#^F`jD4xN2pS#p6Cx=#_ymI67)I_{S4t_Pgv3QnUS$jaTQ<5e0szFu`CVSp4 zS={odB|r_4jos8Re$pazmj=PPS~&7NwOr9-rVH!R+@JUHdTNZLwjTFqAs^>+n`hV@ zBgT;({2os49WvI7o8+L!$t*lOl8w#W4>$ZGyBE(Go7dB&u2LsO3SGNB?0+02ua}_I z1yHxP-Av}1nhhwVMk8R z^>idEpP=4KiXL+Yns9To3G=s`5SB%KBaIO*r;YTqV~)VRFp4?ADb|l$)z5+TA9_B2 zRp^`&sB1&Ma$*Uk?lsShTzVOgA97G!n16b2;{4omYUj8ZrFFVdLYGp@;0g799JR3T z;E9nnyzuj(7W2DCVxD&-XOqY=I!2=9Yu5G`vF6^!gciI%E<8)WJz=ad-G~Eij2O;- zsoQkwXkN|6*oV|Zyq%3qXKKXrERE&04Ca^d3AKd}D|F`rl)AKS25A+LAPdSE{3W7MGLbmpPt|9!$*^!Bm>(MVCl?SxV-? zME`9oXD573=w8W)UAv8V`J6e>i!5k6Fb1+@q1&NMJUNz)qw5vAV(R1kX6$3CuhhNw zCmTz>nO74H5>9QRd&iQ*UYR0;{0yRbN8Yo$3b?^%cs`lW^=g<#b3WiM`zU|v@yBvr z!!l|e*XB7kM~@fnsh2&Hz1j#P)&`p}@HlmM#_%jQev~*N8@9q#45v)fCYkCyg)iEP{dLEYda+Wm4wF#~K(K(*8 z>Fvl+PtC)Ne;njvI(5yu(u;_-;pOCF8vSj>!dbPYO1WbBHjkbtE6LYHaJKbta({6i za;!7;dY6*>TOEysd(z=Hm9@`QCvjf#OHMrVM>1<%Ef%FCdtDwL`!^tyuE1C7ubm_p zIbsy+xC_Wb=lgOv9YF=zDDk{-;4TgodZyOMEAgqiREp)UD2Z_YI=X(Yoo|CWza0^zrXyy4L_xYQ-T zW^xvfAnF?q4x$b!=dk;yBQBc%u9YeY%d|L5meolSuBDEIM&!=(#++#K&;-DGtCv#?CZXLPfS1h`s0A!{`16$1SKb{Bu zc~=Qm^K)0Rui_sKuRqiABsLexGhF3R5;?LzsYlt9|6Ziy!yMKUFR8?SPk}sb6olyy zH(|-DbnKX!2S+!R94P!LPOAfO7u0J=Nk`7gJXEOXE+xtoN^ONd?o9pHH#{Ait+{yA z*HP?EMG_qvh(#6YQ+z26ZYQ`d`ZbU~-Kj%Y9DqMVqwt#itU;HDm(Y}e|8SW4xY8|_&hiT(xb~=Jnj>bAJ6^I-V81#UH=i zq}3V)qFZy0@oW@^J9F0LBzq*YoaA7AdZdk~Uvoh;{%mSS(P#eN6|U0EL4k%F$V+O- z@tvce^C`}o3xNIGO&EKH9P3|J;A(55A*M)u`fBU0ME6(N&z$?>*Pc3=b=so>c&-<4!xOJQQk1h?wR<}snm88z*l_+{rq;uvYkN(xvWx4!YeC7tik^9(} zU3{O~^d+C|A~S~;ilrub!y#N3hBSmI=r6RZfeiOjpegssYTct?Y|glsJ*J_idNO=c zv3x2Fz*6dUJ|`cl8XR_rA#*`15cWn3lt?r&+MqK@sq>!@!!9<^d!evOONC~K3p<^Xi%>%W;Z zbYp+3Lo)g3=Y^7A*bfiyQLpw|I@Wpd^DWy*R$ecZF)8GQ+tLr+)rO}@O#X|UnmuRvc`h{EmWg2x}UjUL=SEXX^VUQagF20kf-d?jwOZgI~yCnBCFBgT9j080%fj!se#T zt8@3uiT7^ULSI__8u}$X$fTc+LI?6k@$~tfl)n%){pnlXl75NIzh^&Ake@{!m=i`0 zsCyDtdC_0TU7^eQwqIhpXt48F1TI}8k2Z`m6>W6Aw}R;sm0pB zbLzoep*MtMIOe`dL}AxVIPl*)-X}?}w{^$4fC!WwZa~~RYELm9vp4ONT0K?BYY>hG z+mbjtmx(jv%j!n%mx()6X!VRxJI&UH;TTE_lzX}IuvaT3RU*Nwv zi}cBcCAxU|(&1mtbUk*pGGIeA{hsP7bZu{vr&FpC|2qO}_8Q^XlOCeOY&gwz*Mra1 z#hVN1^OXe0Blqy0+-u$M`^1GDaq|3dsJ0|wZZOwNM;q$-n#6jG{8Ap*dp30y-KpEi z^*HT#oSb7{>5V=DRd|2WYh^Dz0sNMTDVOPS+Fqec(NUMgNsSa&J^J%`vvbZwS_!Uq>X7vQ?hd=j;cyDz za~R1U3ik)E5&LDuad*sXMgI2zUnjrQjGSg2a$k#+RT%CYP7hTBd`?nV|B($p3aGa@ zO^y48aJ+j+pIDcBIK{lAXlk5v-Q|W)4I^-W8u{zpnW*yBhUYgDrH@U8auvv*+LExz zmIWN39w}a`=gn$U!0n#5WSvxF?q(YHq^U+T8s--5@dEWHB#F$Z+=X_c7n_l^DMJ#hC;7`CLapH`om{mpH7Rx435x4C0c zFFpP&M-KEvCc195;q!w1lAo#mPkX;-H=YX}vXR)-hJ;N<$+aWrPM;gYR0EcWa9tcP z#<;cd@;hIJmDIhpu}^1LBNHS0aQ`0`C(21G6t#skb7FQXlmRPMx?=?-zG1we6?< zb^SVTn2?%w*xGjRA*a-f*Q@%yN?7YxarG>}mPf)a{NEsoKw8sXH(D zwDtDCl8U(XsY~8oOg(kjcIs1hMZXDadZlK~n43D*u8!Zk35gQLI(nC2lN`!1ileVl z^kfxhFxQ>GJ5JP{OmhELl8hN{l#F_bvT+vuC3YoB)yfI-x@(dgi(tQ*zJr!$31VGm zl;&NN#djt3516|jm}8W?XAM$gC^b$eQg@gvqtYW$j$C8iKFcJ}Es1iwFj07hy1 zBfCx{>iT6_70*s_-2jcDBzhGNGQf{@_y%>2 zaQ=fji}v*4c#}z=yDSuHva!!82i_jph}l9WpEW6a)?9ksqBhU7EX?0bEk@SvCLYR0 zdq?U=uznVICJWalW}!=77J9H|m2f8;f1k_7jePn~kD-5HJI;Ep$U)7g+1M38ZO2Qj z`*FP&GgfOD${s|cY@|4`m$aJmyjMJ=bji9h{5$pIPN~J((_IE=J*4YUSBWa=F2{B? z68Agq@=ryT48H9y8Ry-k-sC1yGKF*MowO2h*IQaU_{i+7&T?`ky(FNL>bIyfH^x;u z%=3_PZ#*S>EqSc59-?&QjNW-?nOmM711Gf-a91TseVK34L*Pq}t8AU?EcJI3%l=ME zBn(mF?SAG*Rp_xmU)y=UN{p+iL{K)_s|Q8$_>%%(l$?q0ZHE)vl=!P8`?D*4%ZI88 z9PXsRg-bp#punDA3o}4u;|6t+v`^ z&j;3nqo`jupI(LEf6I2x%UxI4Ku_CZ`UWsJJ^Pkk zwfD(0szZ>>p7|gT&Y9+gpo4E9CiM!&`y~OeR3_KBH4q_d=~>;4d0(3le5u7c!CKZR z=7r#G$zaUv$UeKCY}L>pI9h|yv0E^zP~T`(2AMAMkKM14Ma*D6QHfeYUYw(!9fOd{ zF_?Zj8a2C6dw_NO%}Zht***pLy%{MujHPsIxo<8@^G?F_moM zLFP)|>47_rKhK|8Uy{9a3mL0!(bR3A4xI!4&OY|MnPjW(M5B#;EOxz%#`$gJwU*G6 zx1j}_zNX{SgLJg9;|#9R0(&P5Ua*dlxrsF|{#h}cS_6|U==I!;CpXfORgN|LRu;Uh zN)3QD)Bq@Hfj{$|*sEqNJWX9DzFz00nXE8*#r9@w7-UA%+vKs*$w{7~FT@ts`NcS;jsjp(i-^P6U15>}KBDIW0S*h{E{Fpr@ z-;!1|KE@f^`(&+tu`WL{AB(?Oagz18E&W)7xk^6kLOxoY$j9upWU1H_pRZvp-;Ycc zdmR&B(`PA`Gnc2VIGREI#}9d!oRNpmeBUd~c}v`7Z~wPe6!)Fv<84nln&B-uNn{=l zddPZepw0+uB#$~Ymdaf;5@x3r{j>)1sJXlB&2Sa%E44gPs-&OZMW&bWlETlfGH9_% zzEY>+Odqwh+~_T5$tpT<4m4#rH6D9;$eQz7sgbIZ;AI*a*UUrm`QK%iddSCDE|N!{ zVBX7y(sS}}$*-h9{a7-?eeHnmWPd9bNv1)8ZuWNMkvKEFp;(^xSE6kfB^I%-w(*Ao zhkn_ljgGpdR{BfNDwK2miljF6xL$I`^7>|*Jbqs+$4bQBFA_l3Xi5oGmc}uvsVl@a!vlbCe(Fe zP_qix#{4DalRllS)jf;i+Wj4c(fpqJ0a56EiCRRT}RBJ~|R(SM>hH6F9fsDIduQ#09vqy|>G?d+{B;JVe3^%%o>mlc{cXCGi)UpQoXxus zes)!#xvAyTeA~SmS3cDz$-!^S+G(k0-`q(ZWE|i2ceXY4sl%=|d)x=51syJR_Vw** zenao&`*olB$gh>6Lc1}WU$)+x=a5$7PH}3(M7MU^N;WuqYwx+XHJY6`TOq1c>W?uc z{0x6rPCHoodE04g8>hAWdqmqa&#tx&t2i^YRn#HB*JX~iIiT2{dU(CH?V)gk%&Tma z;A+VdKExy~FD6Pd=UJ{yFv#HN2GO-MN|z*qbTB7MOU|l}xR@mMPN&HC=p<3SpHps5~MtaVhWYH38AKB=4P{SziqD&H} zjh7cYP154BQS2o}5+@|co`Gt--k`;^^7P2sNZtQ6T3nq%4>;CR8oy*L$KFf>gBEqt z)I3Yn$epRh+j^YWi__58mU`U_)yR(0p!QfTN^PSy*G?_9^wjt;N{w-WYIK~W#!zyO zkH4wW{BJd;vqrFCq82^dYY^wG#dX$B4&2e=UIS`aFyDRkC+A2#$aG{=pSxQm8DGw` zjts|A1$mF~NccC`W5F?MX?aJWHTlIDFV63^rWW@_vMBwj%gFdo$KGCT<{2+4ayF(% z1ib!WjJThgS8Mf%n5BnXFZTaB>d8Duz~`zSEBU*Qwa{bkRO&Mx*JI>l_D(t97Vkrj z<0`#JImdhUXcFcX8Ij>^!v5h#%maIt(}*{nMH$*=X>V zGoLP5xcQv5xt;74j>>_SF=1tU>eh6m?nk>EykZZr_nK_XU(Na4Ls{7HEDPWGbBoOE zF~(&f_s?t;tmjPH9{O6(%)!2;I~FzkT)3YxK366^LyYs6{v+6!YEbSGK z`B_R zV(LVmqt@=9894FCOs@nBtZ&RHQ$+52j}`A0GUk|(kC6uMv(E1@Y?6=oUExg8OCS2q z`p8I!#?t$bCQ?|A8s(??dF@r8MgyMjkv0h-->7=TxtXc-=xjzG<)%Sc!SlDFG6(}5 zV*lemjy|RSpduExgkE8GG3d6J`U~V6dhW6S5!3-DKNHK(&-^wYyPM}@PTV`3983?< zr}@;hrcdT?A30ahM7HnqmE$F~;!&lAemyax=O=0iGfw=;>xx#J zF?t~5&s}5~H_?;(XC4A$tgz!b^OW&gYMCZ-+fO5@qna_lZY({bH8Q?(6KQqK4*NTl zK=YmoOf5k^B~QtHLWzqzL*aBM7zIaysAUj@BWHqOcOn!&EAm>7l3%RMIU~jmop#1x z;xOKy{)|=m88yCTMloaCNqx-FkqMd2-e=WL`Iy9bakPmX>L2u*=Jk~9azuP~8^!eA zBzbuWvU+2pbQxoif3|6HDTSMhn1 zYtN?E>lP#Gmtu~3%7DQ!+<%zAMug-b=`H8jSnn(2oP%oI7cTl|qXRuv4D91;$$jmA zP2VKe4i7w1=$!Q?DVUrhne?LYUU5La9Z8YTtTn!TsfBZh8nz~$DEUImJ`*((_Gn?c zPA%MYJ^b3~(QiI^bS1Tu@DW5BxW=t z(9F5SN36e&Am>>?y}w=5Y$BU-{#-UZ=2L&G!vAPjmj6O#a5PzvKa{$~yGpxyS&uEg5X$NH8IHP>osKvUb{G3{9FtDix z!zc1tI_ZhAw|OS=Je5}D|A+DUabZ2OVkD|nHo@(S0j@l=7Vxa=Jd*4w>yCSGv3}e# z8}gKXFRjT~vaY_fn6=jea-M!lT`%5~W$ZWHeyPx1jvyQIAVq@mIa6`VAPu|{ru z7S}V#(Iig<*7L;OI%GgfYyO+Hc*FUL^}dmqIgwhCWypfCRy(_WBsD$A6ZJNt+Bb5H z@9A@K(TI@yoF{EzK(AP`o};N5*_J$PXf~?G(bp=GXBvAC7jG+c3C9(>r@IuoL*!GM zA7kId!$)R5X(Fj*wbEt0yIl5D%dopz@##Qsh9D)9La7ZqU4gkt%!e-9q4uH>bovqu z%O3hnGdKB?7l?OX={MgZmYy5ToyU@aKg@i%S`4-~i$S%O7R+BkKF`mBxBV=b=$(O4 zjGgB`rEY&XHTAC2Q~7}v?F#bn_6`|lRTJsi$y2&5p?C4OhEiOynY4bamTGAV&JHT! z(%KHeDm&=EQY&^IzxsrrpluLzk-^Al9E@tELg)(-f?lIy@q9ZOIeiS~ZeyO_F9r_G zLvDF8R=4L_I@f~7x$KcvAm8|iJ_e&XdsN{aDl!&7NKR!sWAv}TxDP#UBGaa6#BHjN z_>O2QV;47-sdc<$9rMIv=k3sBA$iZw3QXp;%rq%cp+*S)>=c4B$ejPlnaDT``nSwLNAh|~iy7msX4E*!UTacKQ)qoZeD`Iy9A6Hg6f0z=&!ewxs$I2&s{C_=_cDU zE*&1f%y@i19~+Hi&6$f_TxLb|Cu&add@W&WEQN2I%8m+6_v#j`+)0n}rsP`MvSu=j{?5l)H}PQ}<;48TpL1Q^`FSOg|7?Nsa-61)b zt-)YlEry=(M0axL_XaUH8KcF>x{+|}7m3k}^wcDY#4I)Q3~KH9XiUgGY`|uoUDtaU z$;TSex`YYCCekl>Q4Yq>qDJkyY?Qph`1w^9URv0jB!AYQeC4Cf3S9-BUp0AclP^)1 z;2!J!w^Bq;&4QV)k|ld)q70r*KCdfl_;0n;vDd)<2=yyhd!kN2BtirADE*kT0lZf; z_tN8tXRGOy2~GN$P=e=asLF^*oX0xUh+51wb5Nok=hK^$!GFaW_HyLC9ka2C=lY61 zN?qj#yhrTUp5t{rJH)ef1^X9&9+&Q($uh5bvZOm6kiRP?%OV$Y_=i2A;yHTvff{X? zE4E&)hT?rB%#WBiH6#zPPLG?5sEbi85_|KEoCh#rO;Z!n9GEw$O|a)a4W8#q|H#4J z1fCmxIZMxLIcFwYKwt2O6BW8+pU5%tdPeeG-ORJTU;07Wnv)_O{^7M07^P{@A?a4> zptKsPMcz6sRxbAh`E%@~w#U6_>i^7)1o->)Tgbmh=@C*Kfol~a5vif3KI`+sGkx$g z*8680FiuIm#vfT2{)Rox<2)&R<4F^^gxs};K5E=pbZs!E+l zqZH}1DMi+@KhtJhvQ%<7C_eM4VcFOV9||;BK2eP)%h(rTPF#3Zi~71qZ2ihU#9;D_ z_w~s0ibSW9WI%6_W#m_@sYcwZM9qYs)O5-wV|hA@n(^7_(lZ;Sj%UHpCmYuD^iR63 z(0%bx>Q=icbsfk(jG4)M^yYtg#w%ayNSR%~sj>o$)MlpD9(NNbP;{O?~*#sA9F5jf~hn0!dm8{;tWTbev7

YmD()?v zsCQP+O=^#_Nv-g}|E|YrnHeW^R%+xs$&Z)C^2M-Zr&P% z_4ZN7vu7Suhx2ttm6+C1ACUerKd2w@DUbU&&sc38M_E0*Sh7lUE+Q@p_nUKHAJ19f zM~+giE;+%M%tL!}{`o>0JT~MZlfL1j-~X0HJl{i)lP_P-d4J|n`HkpHTlu%#b)?^u z%fJ3eX8NwMp8c|(jAlRNqcBe4zO8M@dfrYe@}!3B9c`0aEBxU(oxa|UIVZ^a*{|V_ za+&&-)#&3~h5dmFXVS3ud@iPCIZLNszr^uHKinr*mGe9eOEdGRSI|h_S1yoB+xa|n ziNUv=G^nEU=zr)aP6-9_!zB&a{KkF9nD&>t@fnH%Waz}jfd zB4=3>SRid8g0S}x`CQgePVx*M96N_2Z1ZV;(9l zQOQ}K0y$HWwfoYnYx||+&QtpEgw~c$zl){Y*+8h{3p98xS%X4djq zAMduBTH@WTXtuyv_PnF-6YsMtbp<+BV4eCO&cV-cmg7CBsgT_dGx>aeUSmd5bu0eL zX(;oX707(&fdAqt`=!)NP0Yig$_>Q((=Qn~ED%$<|Fr9yj9Q$*je%pTvF^_rs1Q>dS>OMe@87eWX6HA66zEFFIIJ zrH+fNx3@_cHBFZGpti_l_MevJaaPth)zu#_tkgicOT*vESO(r3A-zTaJv_ZNvLy{j%CjlzU_^tGQ) zzxclH62pDqoHhXC8Migyy1T)i(+cYF7A5}{Reyg>8cn^|_US0~Fb@aw>Pyj~U-Fjc z#nFB2_XY6!7x7&9?I;y^f0~27RCS`D;Qcvs=U@KXP3}ziDdkwVyO_U;v$pA|b|V*u zvZ_gjC%yCb2Elo66t3+eAI)51a1&2?Q^h9J&Hfn4{p93e>S@O3;k40F9vmr@yHNqS zNL|Y$k97F(dF%c@PNr4xzoF*SJXcTZua&ob?6q^2uOc~3->URFqW=dQ$$v~; zIdcTsdK>WZHFfch(qH)fe)*>JK-~%9=-k(UmCNp7eiMbR(~vm1Qd^C3`4OlwkN+;l zq1%TjblHq~M+d5Lxf5&ToOcP>k%ff@8#VO|QaMz| z9|Pmbzp4ASEE8>ObDqN?PPVjD;W4?t=>rUyRGsk}x!2IQ31VL2&g&#M>R`YN2iB?U zFh*LRAQ`^yWKF_wu|EBjSl=4ci8HZ%ljLke`utYr_1sKCBR(hX7*}mii)VTUiFNk;> z22;oIc};iR_YOy3EIGLEnaK2_w)VRO*+D+Bn7xf|JIGbd$-?pZHdLsZC}XR8a6Xbe z<}~VS4Wtjp2pc_ac8eRYC!7A%fAMpyx*&`3t&N^M@v=Rd9M;QlY~%ay*g)>DD|HFq zB}#3O`wNahGC!~N@tLd>D0J1!>=(QD?&!8rxbUtt*hnd^El zH5yJ+FY@U=@eLw3s#%C`Kd8T%Nqt6gWcso3QmZX>)ySh=c*W;oC3W3bvfdVHl=?s1 z@yFYR*!IzY3(kz)In&$yd7|WpyTPqqI8L5SLio>2`d8YJRf+W`YH-}09*)thsclp7 z``yS1_Kp{u8+p&x;mE3Nz={|?|GVg;O`XsguRP$KrALV|Nw^Z6g^XqjorhPvRJ+9) z;F_GVok@OnF1eX8)Pbd6ZVr91FMXpQtv&TsKXYGlA^*EDPG0( z-MJ*hC1>K>ZStq&tY?o>qduS8)~?jRXim+F*ETXq@zQRD8Wc%^V*?|qRLVlt6i-*^L^M)O)R$gt}o_aC~M%-*K!}$8aBr;y&4#UIBa_g1Db#fV}5W zdbu?V$H&9;dEY}_*Y*nC&p`6v%;o-2UvI*3?;> z&ZnYR@|l@YyZt8Wccli8m$QF8oYlJDi598GV@YR=N7qSRnOq@lS@{ZSOP)uhmfl#o z-MmBgX~E%*QxneUQa87|bGB*5tJICft5eN4;-s^I?DhRbd9lMFx!p{%WiHQ9^5iGz zg|s{@UTW(T<-l5loa4RvOjhyaKZ){MMLp%elcY1(+3JQ#GLk+I$7Y&jZv(#0vnTCD zqMSZQEgsG(j-z)+V!ly2p5bS6$|(Nf>~nLy9U%KVoqS`drSY=#6uH~J2Kl{`{?fi` zJpPM*9`uKf{acM{Rp`f1mVaKLX9R0E4Jv7|HJrYHKlnKx<{8TU;vCP?s?)S^DZ_eq zX%+T&QseA(a{j$Jd&ru68`f6hm(W+7v;CO^RQUOWULpOc=hL2=rvLW2tEf>rNke@m zYS_->xjB~FJ_%YxUyMLdNj-c9kT)bdKBxlgLS&WaeT~4TB5LEz)?>?KKFd!c;K}+? z!5jJx(wn-|4m~|_ijqn=PJ)IhK2N8AIs@ANKb&sxo{f%G6e!}nmndc4Vi znR5*AzQW$a1MbIj4LH=oh~>MTRG6xi1H&1Xj7khkBoCp1agmN zZ=h`m&$vff=&7Mspp|Um^=$N+$9h!lY|cor{-R<{i2ID=6MDV#9GicFy{OzwbYk7Z z&@>xiWY@p4Z+%0Th1mY|ldhkQ_`n=`xR77W%0ef;=QYN2-~J+VzlZz4bZYgme`GC_ zg&H%c#~hGNeNK0AadMWb%p1v z@U;}Vs_8cQP1dk~k7D`mset~iO&sitq)A1aINr8NqjpLhu0{`{k4jvfT`V0rA7omg zfUluQwptXZN?p3OWVCd%ZF1>ck#smyELEr4q~Aem5bUJhBQ+i49~R2(Z06S`ilxL1 z1xf@2;kt7W+;32igUc!eU(p4=ky49&_w&Y6>? z+C)tta)<{U>4DTL5Zgxvq0}CKyj>WK5!-?=f&63h?E#qQ5rlxGAcO@|KWIS!u6Cm~ zgnuyZ#dC)2GUv<2(igE$AWq#2M!k5>Dn5&ZGc=g;ftjpP!8k9DGPmo}RuIVtt91(%*N4?9bSYFawf7tQ3DE$H}(9?_Gi+j!WFUN_TGWj||O-OL!# z(E?e{x_O|5^9Ss|kmI^Gk=jVi?VbBrFyx^btAd%IZ!u#jxvl!=%xKq+HTMnt{mHBo zT`}W+Kt9%ZQ451?VfF=jSp_k-(y(68o|JtYr!PFZoOfOEG) z=wW-sifQ%PXP%Rfm4DEWt1fkYSVMWoo<`h|d>lK+?`8ja@HqDDCsN1p2=m2hdGO0( z-HrW*Q?uDC3L{I&Jl?J}dsf5wy?V|OH_%9rnp#OM^yci6i###7Nyfn@^2ndHw4SbH zGgtthIz=(2ydDElHTkeG%_R{~KmgtNflTx+*L==pvtGJ`Q^1--TC5C5I-d-^9i$TWY9xJn*D z6$Hn7tEgkD@P^X}0jtueiACQ$Em0%z3g#9)%JM$?*n z;~LJs^Yv@p$vpmw#-Nt$X&#Sej>fg-5QDVMTuUvZP;&`;jI8&Zs}+OHsA%+F5RF~; zspEKq>+vT2s})>Jf78DrJqj0nxn}?3`&;;4L#YY5G8%6d@oRkyUbE-tbT1v9UU6QO zeXa?I%&0kzHP`X1-&Upnmmi;fOFCw7-CZ7K#>j5`Z+?&V5q*eQJBk}?#=L*1hZ?{& zWae5)QAhBb3JuGZ^7v2W(;V}+T9ZR zX7J}%th3^08Tv@OkyW{u$KDoaRX6A3RGO9gdR9ChNbjJ-oSRL~!--tJ#&w|FX+?G) zu93H_-zco8^pM&ocex&oc`!%kK||iL&3nF{L)}x>=KJ2WVu6Y^`kC~7=Q>@-9@=;{ z*VT0XZmz)%d=KIGT`a-+;I55+e|TL=T~rv5`d6jhslQU1rJX%!NPV#GM`}djnYIl| z9P*o+`21{}@PO12y=$ip*xKCBwxYt>f@h0U$CS!Xb(&-H)A%Kwo!Iku>dxB7&jyxh zm-=ORg|m?_Yp1?hKGg4ajmxQ*8e3B>2NTZ>DqNH5e$zSi&5P92UoX{6J+$uR8HYy~ zQ=1)JmHJ4TnA&dk@>JJViSnRsyp-LRB=4rA$R$mZEObkj=m{oSeLYFGO-Yp5oMXAm z`6ZvtCh^^6kfIYQvTe0Ne*9pZ*WD;jbxAUONwU=D+)MDiB$>F~Bp?1TNo+fVOkq42 z{DAD@PtM8B+%Ny!FvyKgDKgI9C~Ho{N!f%r33D(?vexJEy{m)hdKBmYlat zi?2P@7%`p9VWUXuD6yX@k+}LNJ*L%UDjsq!>xdpxDpQZ-oSt009&aK!>(`guB6G%q zkKuUKhqI&nT0`ypG4u5Z+rk-{CX6@7k)6>pE@VyW>oz@lPG&8Lap#0ZoH_i9IvMut zE1inKknZ8A?99CMdj!Uh(xc=zJvK5{yE%n%UJz%+T9Z+nK`(~o2E5zHoPPs#{udkY zX^0W_teJh`|NAhBUK6)imnunZ?qVZidm2#gG1;LV?7uqGTlFDxpI=EhIn;nhlc-5n zjoge6c^NOpjBUvAv^QeJaU=H4rKb05GAyIWP;w45q^=30x^SlER3V6F7j7vJb)y`#Ocf}kuWe-^OJ{yZxk=Yrag}v@%8GRXZ?&MrDzwh&GYCp2(7PT}R zYpVS(&*+rZM2?s95<8`*$a^md+v_RUuer*+7u4%5vO`2KC9X7MPoL+5KPbo@pEG@W9oN_6O>z$Y&|4DF%7k(UbS*zZ}u7*91R7`p;P(QO%Z zzqc^X+epviwLA;RwLe`HgCuXpdNpFPmG@)`W2YxyEl6`BtIj>U*$48TudImI#KHAL*A%h!((C8TIB=J6dXAH=*YgH9$bN}RZRJ6ePx&<4y zSm3k7Lj4PBS_WG&Wp_R`$r&Skrx#@?*-sny>e*UqANWZ239Zbj=_U6bXr;*kl{9{? zKqIm{Hpdc}c1nRE6Y2YEQvj7i@a7pgkS~m{BZJ7h1z~9WAoi%JKNb`XpJCJ_9~^@x z^QZxKJ{o(;TU66q;C{x!Ib{nzE~iewo(#?hSz+Ik{Od_F@#F{}^6QFFx4U{%aqg#; zK{YhuKGs{thBOfeeG@sBqr`wMHc7g{I3}L+Q&3`slA3KTL!qf1f(=(g@bq>Fo^PVh zD*2Q(EqM(WqH%#|_~)~HuA5R<^I8nvwzNCufd(Is#u0b6>ndKjmHQopUd_zMDF*%wMm@G3VsIvzqJQ*C!iwD^bhU zm<4CDgH7GJAFO2!iwu~G+{1L0Qm1;Q(6u^2O`v^=(!DTQI@U;*FO!nxL)Qd(RyA3o zR%mf?odzd*(1$XH^TXfNxW$@+tpoS*R@B?#p4#nI1m3RFV|+dOJTs4;!@PI6)rg0; zjCd4hfW89#7T-{Bwnh$CU1J_fjiRK6IVhZ(gBGl@j#!}3Js=l%y{AG~{(wT)fDFWv z(?;3oo-7XnO!U4;lI|~!obNHpiCe5IueliUiTmvC2lPxxr+$M6_whC4EvHf+l8j73bPl}_$$7qKz4~89gxZj= zv`XFoA?>XHn%=|rKd?nTc1uZaAS!m=*Ywy)46(brj|yyd7YqYiscqPCPzJ;9B*h9rJ-n`=#*ZsV&Yobn}wp+{NA>VkGeojI3Zi-4dD#@FUOJ`?# zY0__bGquUTzEcCK=7(M*e395u1zc1jfyd~#^)`Z(tv$5Neo|>9$EIvk_@eq3*$)PSHAJd1&l0mLA+Q9QvpimED zUE^8fgR)3_P%PDtNay^6ayP&r;gKfk+n4^8&MK%mFHeFm+M9i#AU|kNE#@ZA%dj@g zSgrFPTeKK`pXd;?%!pMNn9oC&sN_f!sx@X$_Xp}3``LrJkp5rCv#{j`^BxXo;bsss zVE3?wF@*ib6Hv_ywmF*>Z;szo2(&)a?JS$UPYH1`Z(Lm>)U8Bwx<2~+R! zST2%h8cp4!b2bc*v)G%(xow3){i#r))|27+*w{|}Umo@;EA`kZesb&!*}*c6Wpk>Z zGqCH$cTUld&!2UZv`}J2?F-!3QDJ}B=a(nI5 ztw`s-u;;2KQm&w>-QwwxH5U?$0^)Oy+!A z?0Xi&1L$?k_4JT=R-Boe2ft-`P<>*qz?A0F?RaCUy3|ivw`nA6k{gM>4fl&niey~{ zd(H_Ydi8iDfDK1P9C57*ML@j61U4=9t1IKq?(s}=;be$tjs6Zm0-WIJpyvczqe4J zZf6B1Ut(Tga0r@r8i4YvIkz4gfN0KPWjJ@0;yF5-6ph9gqY;+JJ)V_(rHS{9g5H&1 zd98RXW!F$6$)bkRi1*4CzW!mx^DX+;f6BuX){Ad9^pm2h)YxYEv##4(^!uAg0<+7X zc2uC^Z+lF<%(?54O@`g02b~J?P1Lh8)-l5Ax_?YK%xC`YVfGI#Hlm7+zURRlZ!*cdKc|mf3K_z$SYdJ)MP>iCm*^=lGYVP=97k#Kt=JCe9a|`Y6=Noeffv$Mn*cBn?j*#hJb+ z{hB0*XANIWui=9+y?o%sIc&0uwLJC;oKTVToU6mN`Si1S!Trq{Ejkvl*Xtm2hB&9L zF&UXFVnV4YMi|*o8*jL0d*|kZ-+Q(6J|^o) zrZU-6hYsuM({Yw_8TUSCukuyNgwUZzJUdU`vyKS|i?h(>X*N=`>Hq$g=f^o4Bj_<4 z#2y6&y$5qYDb$a79Nk&-oIaEF(@ROB4l_yc6qD5NktFXu5@fVBQLHCaa4F%7Ps3C= zdC(i9S*u#W<7xc24q>c4KAxe)u?jkLIiSN$;asmaBAxTY;ua>;qAjyky-A^bI^o4(_3|#2fxdOfTx)8}t~)|5dQ#I`(q&kYESVJq zrwMulHl&WVf*e+|m)O%!t@vC3jL#zx`Z5isQ1;NqdCNQc7o@deC;XQvbZwf3xX2u& zvS)i-r$Tw$I0$hQBXQ?+8ro5({aB;EZA(nTf+BO z(Id{@g7|^tyzV+nRYShinIC|?)0nr*{Z>dr@_L;eW$O*j$=k`t>GTMvu6>w&y!%hM z$>C1L^2s3xXUXrh38haTkMqD*H>t{`f;!Kc&-*441tH{{YUjdbBY9GfVsY3IfC+yh zq3=b%vx(dj40e$rDfC~vK%Q$l^?AosdJd8MEAJ$chl^!S=>S}cibTw_G^jez2aUdR z@9x?p&@Kpd9z@d1o%znmIXHi+j@)})Am;o)OuiO{>LrPSjmh1V6CFW%_t14!=A%GIq*JS zS9*Uhl!H}*FuERfP-QBr&&!4WKm#dJxZM*%->FbaY!ATQ zz4UP#or(kGo67BQkr~r|%eY~I%nyyktvqtIE>^^sY$$iR`NN!L-k;QnfAcu6lk+;)lU!I!)|dJ*|9x;Y&IG2hN1MN|+C`$X3#1C`Ife*5 zQm3)jQ8fo{dQT}isZj0=WR1v`eVj*A(d|(V-mGsZH3$EZBJzy>J);rZCk@q?TCuOS ztJL88uQjD##&~jY+BC!mbG@XaU+2j}X*`|%{sW@$F)xdPkk}C z&`)p`bD4{IpL8S7>tw}(AQySXdcunmfq4Hl63+jm(l}%~=63SB}Df5%k62eOP~LU3p!eHAME_czNmJ(2KltW-fLzn{MiX zLb3D=#LWAVcuIaSX=yH^f?cKb>>_E)^V4)kBnB>`SHRv}9Qy7gLwXiSZRXlPnHt56 zUJG1va}ev_K;EkJ>h?%8@%kz9NkgugkSn3r2{X{;4N%j-!w zub*;qUm$y!cwIRD7$@bRR)&-8cwZn-j|L(lKN77uzSXHm9&@0RY+q0yD);`F!~5Bn zI2C%!2FW1Hy_(wKcH?Q=2jo|}BGT_{^Q9*+7Qg=ys9C-=0X!V^bX zB}H;!N-*?lJ@(w9zvKscd&IcP{MLmsa+wAp+~*d9f8fLiOY zPShqn=>NYYR#sX)5qc^d!?qj9<7ePc2^)GHPn0{2y)dSh7Dp=@(25#rW_hkJj>gLP zY2NH%(IQPl4I=p-zENjbdMsXguO}~dAsn^bm?yiHHTB;%eA<0LvZl}<&^-(VLkx(h zNlk#<+`MiH;xIu8*Nya4I+cjeg`PHa!z3yllwcNxrGK zH@V7ibe&2^auRN?1bxFH;gVB4!4E|Ox>P=&E$QKw`blbk8@~fIPUFEr$bDftj-Wxs|wj}oBhm5Gn{ZTQpDAWc_$LA_!jMm0}_zdieu z`1@{t7AM1=ctZ0}7|gkeNDU%~#WieS&p4^H#T)8~FwDQrwN(xJJ4M)#Vt+sa$*=TI z=jXeS53P^|T{{~hYRAgj=k)mUjKF}U?4{jKU$z2ri|W1NQAl>CT{vWFBK9B8z@{_2 zjyGc^_q`Vszr(TjFmshWGLYoN{-`AKn0haiIu-%Lzx0pu&A^mK=vjyyv$>#MzMt*=EDpReUa3lQAs`XI@((ibrRn(2qQGoc?89;5 z`I3HoO~cTbY)oO74D_8+40A@TY;WL+%-X!qH`2o^g`66B)v|8!vNDfr^0xE`Oh|-< z&z-|w8%F+&m-t9>ZRA+zyBd%>j``qydES1LcdO%#bT@v^3i>~+&t$JVeI!f9OPQtK z7{U8L@09_22eIZcnLOi2=8U}Z!pFy2G~n7<(#ePB*_fl4Am?6t)3-PbickZ#^FG;< zU5vl##>vmN%n=^L>*a4CYmk8k4fuSGjuW@N?4hG?MK$i1dK6{gW1K?0@egyT-+IEo zWCXso`X65P4fV5g%6MrO#{KDe@~wQXCppu{@P`fE=fujdsh)6h;n!WMgVoK%tcy0J zohHYs@xteh;TZXg=jU?8<$I9Xa(|-<(|!?edXn@H!;c+_c86z0mSU7`mDh zFy}peWBL0ACLWLlJyH!ovGOxy^vWW6Y!H_&lLRtZbRB!gF&NlFlSz!5sEh^Y=Xfex2j$WqU1rjwIs! z;tb3mXG4Qk`=so2Z%j#E1hbC3dEz~+-)cj7_FGRV=>^kt_Qg3F5PBs8vp9~q1;@!+ z^0_fSVW>2M{-Gt^g7&p9EHnFQ8k!GWsbG$|KA`>GuQ$z=HEqrA#~+(Fj#Z?l zSH7PT+~=OztA)PZICa~$v8+D_T}~2(Z@fI9*XA*Yc=`K>K^_h<%7i?6)skm_Lft=^ z++m&GCb7>kO7&_6={3S6>qaI@cIN}qw4p)1QE$#`pCp|)UVX@nmr_9ODg=w6|d#1E_rR! zJ}(4xP~yf!W>|!hIpnkTbD5Gg6mLwvtwO;DZ``TRoQ;Y6dosNQwyVhSDAD(V7Ybi7 zha;U?^fmchM|$IwFYDN!nbkg%`P7^v$bTxw03(Lj=OL5qJ|8 zj`QauFq-e*RUF0)l5q5CqlKPY#bs(bYaHqS;KZJYG%cFfCeN6|p3I6`Y?=@O)e`FQ z&9%%LjlkdT)LO3b*o|9d#HhRx5=w>08>Cw@;JJ$#z5 z4|J;$F4UIp45ok2ZTc|QXAa>idhb*>;wa}c3pJk+S6JKGNxo1=uf#f;7+ai)W3{s| zZwUQ%qRGEUWTL$y3lAP;V)_a4($qVq24pf1Gy``zE;grTcJ@yeMx4*Ywk=uMJBmI& ze9lHk(yO2;GpoyzmE<_K?*=`psq^=3nT513?8|7voNE4DJ=Z$b=VxP~ne}Ye!XNNe z_M(^Eoz+O{wDlC*W>0Z==OyLlHI!BKR(v=_C2`d~<$=4mI5zNJfDB23e?42OX7-EyYo;KM$fs9s-5?Dm@~2n zkUbo(p}$!mZU>QF{H#G@ELo@_!SLA|f`6!yn7xCcoE(V37lW{JIr&BZVBAR!#`|{~ zGT%XXdY=2g-}H*}<=3e>4H*y&$1&WK`wqasO2Ig-)u77kAl&F54C8Fp+tooR=*r$l zezxo9Kn$S%u;yzpT&J>Ub~?EyYT&&tvVZV8`KOuDFf5Kj&&7H?urc@cb`<7QYx(98 zjmQvY8nAzF!AE)m^dO&DL603H^ypS28vXn0aV<3(tLt+A%vwlv7CFXeQ8;j)-gJK4 zn^$EGULpeD;BjOT#~PSs!R=LDS@PbZljT zV|Uh4zNW!h!`uW{{<|r2C#G94JKchDr7dXtFb%)S2rR3bj=!nfkG-FUO<`%w^Ja}9 zkUZ6C3+5^;P@cEoLlgQ-tmpSgI;tt?y|dT?EKkF#GU>S4n*ZO7dDTT0d@h#`rz%zy zIa;Y*Fz0qAGie=j@un?37u&P$|1%dO`}5ze@^IlOGp-7Av94_%iU*R5s%k}_DfEe$ zMlZR8+=o-^3dx|(lWfIZ9s2{PGG}QRYvNt_*-fli!oA-%pFHe*$?qL%MJC^0KbyHJ zW32e|iFz16yFb~h_&8q)Y|UQ2jt%A487JxC!`$aeO=No~Z>enWEk`!Ao zwJo{C+VnkL)=0um`bzJ;Zt~%(Cws0{vZ=JUc=qy?e@`l<4msf8$Gl`}inn;>(U;NJ zM}l?k^4io$`k(TWH(%W(!LgCNa%d<{yWHg`nacA&J!Matr;OXlEXCh;X!zu}e5t6w z#977iJirbgKGE#j5XR9fD8Jm#hm`xrrRF5CCqF|k& zN4a)-s1xbQXwp+xV*mFsJw_g)r&dE|nRTT;@_^6Zh$z$ypvUQRX2AbVCNhn@1+}hI z_IeEDb5z_>j{$uCa_>YzrDV^%AL~f@Q8>|@d2w_3o<6KivQFCRPZVn}Y1mxKg2s*L zn@G*1QAZ2Bs6pY&?UZh(%+O^M}9pEN?c_7wI0s!F*nhr^%nI2IpX+33LUMr%R@5MmnAI&08#Y;CT)?{Nw_Ma_ zrkr18GQ@q!0wpmwBPEwTtK^FLeNSGpFO)U9QKPKf_w$+gNKUx971>5B8c^f)A7{l* zYYyD`49>kupH+U=u;saU+LD~ijtk~Ky8S6PdOc2=5KuF9^wgK;OS$D!t4@B@u5G(K z^Q{#+bN{r?Z!D%IN^`FbR!WywwLH22Dz4-bD~Zdqr!`NgBc_F;PWRKFVu=4TJroVmC1in+c2 zUUT?sm3igbShMSuz9~o8k22HFC}ZeHf1bT6ovN^|SI;OT*-uwgoG9aR;$_&BM7iy0 zloNC5k@2@drteOYmiyx6NP4`)@ckLguE@+Z$<{sxWixwRX1FIx$V>8yiShEvKT&eL z*-IHi??&cH7k6OK3wx4u^o1;IHb|YMIB~s@ApPj$UDPQ_hFv9}I9Q1jTpM1=@kXP@ zN^H5WqPG_Fr`xMAg?xdJ9W%~4d&8gX!`O5$^y;NV@=x|waZPzQ&>J4JnG?5*zKpE9 z{e8(3XA`{fG29zD551A5Q^LLxb%amcE0{ddE`c5zcI0mgRY*%xLRE<#{xiH$ae)uk zo$$q4XV!emYf+^){TAur|9q(y+WA`iOpU;#2-c@sN1$~Ed#miYetgd!I_~eC&uQ`Z zYYRwc;8I%bCD-FnAsl+HJB#dfm>Czr-&Y6y6)j48(3|lY^8nZf z^J8x~Vz~yLv5PgY&)i$HR(Y3u-Otnl7PesB^l2hC3^u}(Y~%E629)AnH0K`!YP?|P zG}n*i$OkoHUCMtAwX+S(k>*;jQ3E6D=?&=a$3MFoaq$rMqcGtg>H?NMXGgnD=;@;Z?%Oy_!V z2zyeJGcn24)MmO5Bd5rqfq4}@ z`8@+zyKBqrjZO69&nKh9I+`anyHl)pqDvN1`Tu#@TqEw!L`EF7v!z+6bSVq}p3Q>Y zqW|R?OPW=Z{?t)+{Od24pr+E%$5Y-;Z6qtnt$(2xud}@Zr`Fmb`lbR~`EQ?cAvk(2 z7%}v3+Bz}>#o_eUyUyI;wb4KVS?|ZJEo_QL^-^TNa>%H0{PD<4$DB%M(TC&F?fMox zX3s*m=T;Q3mLE7H5B`JbdtkM~Og3cGmqy~3+d|eIqqp~AAGt<8#MZHi)ELLC>vsx_ z+^@ic$IK1QwaLc?3S8xU683;z7$=y!!{howKkP-zHO%Uy*FwE5C~+(rt#;`V97-mw zEc2!(S}^_uGtB-?N2T8uOrMaBHT0Ky8JmY5$8*szn7kgxAN$Q@t~o|^%IhHSlYQm( zEqW<$Yb4z^vMv(tCp|uK{!38cS${jsa3W*5(;tpmU4{6X$E_F|C2NfWF>d zJWo@$Fw2@AgeS?x4@jqdJfr?@l*_B}2Bl}Q~ylFG85%->AMtI3Bc;*mIzBwA+QR$cvcovZ}$vu#> zT+KDx39|)BTC%1mt$6Ck4DLGglB#QkGuK-_>|0tm%}s*dsO0<|cc~ssma(vjxYSjk zOLnpBHYpJIojznmHgW7ghHzUjt|bQH$>m@ie-(_BI1L7KE&cc*Ye~iI+j+(L_bv0% z(&>B5Idlx?KeyUvp@_C%vx|kdb~^f#Q;EKshgx=dIPf|bUM^P5{@aSHjp@A=;wATY zH`~dr9={)OozJz!suf(P_adLt zGX&H1^p7mH1(Cn>$YHIo)JHwG6)+=iFg?@$wZO{tXv`qa!*eWXy~2VE3+X$~W3l5} zu}iHyw6e2eR68q~1+x8L4YKs7QSO{&U+cod;@T!r^kNk4FBLT!CHm3l?;Bt5G(MQ` z>Uohu_&3dyFjjHyz%*(ZX>&dANKdW}P8daM}pvX%qPs`oaFn!tD$6*V~$f zHfvbR|Hhnv7TI`5FR9EO>_?^NUv28hjmS3c<-dC=k4W3?Cgy}4kr~k@`E}1Es_zE* zPLJOjiAv1>L{25o2Zj=ViiQ!R+

53LT%t#X`a*-QHQ1DQDLv28vpkyBqqzd$d{+(TyWlolWJwWz&{OiHR2 zo)+@)kLme$$p{~wpFj_CpW!?|WGk0;BmZgS`Qbi1U`iG~PbSO#j=42tx?N`|)NTK= zQ?GeXkB9Z-JWnaq^<3=Kix4L%Cya8i-a+vmlPD(o9^~F3KjT7w$j|h)qP`Nj!k3(+ z5A}N`Ht*s*H%N<4WjKe;)1mVSEmo;`j>;LacbgHDzA)?IF?%jKzqHuJyolFX2+SaZ zF@?U2&g9r*=|6EH10Tr9^m#xZ#52rT>Y-3yWi4paCWU&&4dyM;7rONk`ahFHow+4R zGO|rl`nC#AGgVmghyKamsre{XxE<~bUwR?O=1?=9q{A=How0f?@=I_oJx71E4eY_J z%Q+3q2j{VEre1q5HJjdSWEwdyEp5ZxYo4F!v+1dMo%{vsJYP35%V)7d{h+5py&{cu z5ccgJdYmLxxE`wb@rXFhG|KS#Nz%@d=Y`j6+)!VPxU9tS(Z1NZTZMYdnbp~Zy$EDw zY#nqM)Iy7xC>@^cHsL`b=h9Q`GrdheGGA&m3Cz|gNqw4+|C_p#biOg594{_J-u&hGnu$tDWk}wZBRFn3HOxJ{H0RH#ukaoFa?IG$amY> zWTe_2A&2eI?WP88=5o)`hWi6^2zDj1{y&j>lsWWcToMh(=h0Znu`%|D9#6Q=-yBG< zKbr-|?b0zz$F(?ly=PA3^4Y61dm&l#9rQpPlZWOZd6-y~i(`ZRr8)WcZSOfIlaX69 z&{q;;Jfut=JM7Wg<4c8-I6qr~aH9g1TH3+4p9bHnhCo+egTh*z$EFOxp+GX{59kX! zfEmwE*=IF{eO6nU+wc!x$GA84NymX^=~(s5f=3o<6rYFa%Je<{$Z_xq zJ#ko%ezw#{dIh(Xq)shm`!sJU#Xh=s5zWNw)_;t-9fq|dLs-!c(-#*?rylm`!nwS9 zGW)-V4?y)0dNW=Qfn$>a*vuub3=kZO+7apZjp)IP`~^T{Fm+yZ<34M+U5a20cm=6zX=B4$Afq z2KmI^uj(*K$pc35-EERnV|;+eO8mahKMOdIUG}9XEBmob9B&?I;l;Yi!3$cf^w6QW zmX7`EMhvEQYv5cuslE}R)PaxOH6Wb~+Ta%K3E-TyYj748a@~AyCpF!xtl2!_G5jW5 zd7CUX$Hn7+v5v|9ghli@e!cCWJU?raylX~jRsW#ajrT=dLlr)4^+j8b(^opG5U8Y| z?)}9$_n00lb?7;GMvL~{n5A5idCw0y9;X{o-p5F0*+4%UBNDi;IDR$@>7U4aa&BM4 zIsV>I&S7`i<3w-TEtl!%vV>kZ~(V^v2@_KW0h`+%(Ka<{v)l8VkT3^l} zBhIX5UePR$(bSgz*}4(-S#|_TgL+LaveH^&&EsIlGKf zYE--oox{XoioWQ+pWec&wfNVGo}SSW ztiS8fW0($YH=9`ZFrw)v1E!2*eJYPy{CFdx=44~_V`g$I=?7Ai>}fnb1PocoCQrG) z8#%^~3iYp63iW-?VL@Db=(;D$=f&J}k2xq(a8Ul*OFyMcM)_WiEN)vBLYH&D>q8EI zJu|WT_@Kx~hmG9Jmf-bzQALOMlXdvgo*7i$CggIj*T~<5u{-D+`ON@js0m3LW|MDY zO|}l#WGCqHv^*1^`}3H}GMk+1opsOXtI58F4o4MgP5l4zj4#X{(y2CcQbL0;uM(fr zvuOx!X2t%xb)@gtA{lqIKYCw@LguS9`ZVRDdm|^w2q=^@1^v+3NsqUNRD7RBU%#F1 zvY$R>3z%=)$CrAOhGWlcE3S8Qm3QRbIwc3<26bb@KJGExm~l@oZv?YjA~y$N%+n~G z8N@v0Usim);V2ht6-fBz0QRZqk+qf_;sR=|^_-+><$SrYy&t?kZN{Wy>^HiegOXmIneK zl8d>PhH_lXtMZ*?iN6B%3jd5J~1%eL27)mXD&DAuNrKaVicNN3cBH4DKKYBi4 zp6o^PswZ+V(~kaAM-qi zF1KLAxm-kqk~`y`$md6Y%-hRcV;wceJGmG+*+rb0Gh6d-9#4H{%~(^(gs``Nyob#E zPCq;T+_i_PY0gQ*@;c0|E@~j>9ExOMBj!_iGq0w<1qXQ^9`tdOBYlfSM?P-o1lAOI zetJ%z9=NT6R9%)Yr+P4dX8`wA*=ewUnTzPwE;5_`j0c!UJhmhI4$E7Rsm*1*u%75b z3q)5p2y<$(r#yu@%Tsd@aokycJuVQ}s37#2$NENyg*kQXL1d=U$2Eo0pFQubIp3X3 zPDO>oIat!LzC3-9FC!ZS(4!;@ky$+d4m_Xt9mQpGft*$J$B<^^<5O}wsS7Y5}g9Udsk~{Wxk@#`+(_9^dOkUqI z?@}>)S}xqCG!XyG#bO`I^UyO2KY0I?Qj%BQQBPXz%9o#a1JQ) z$m5rItPMbobowwxk%v{#2eX8e1U@Q|FE@e^{ukFd=hG09Y{l5EUh?;?Uvj8xAZC3h zcSf#x+l^d==eWq8y9JWpf?9cF@`L*=^n2uWAvYKKpipYtm?W6)o2=9@=bd}!)m5l%x3yxir?Y&Y!0ZU-Dc2~7#01uajBm-M{&AA` zEo@SfTx82@QP|_22HTt*q;z$ZRObSj#{BUkubFAYUi}K=b5MVF14%qpB&&0Rkk0Y# z^V2j;WUVIPWqsN7^^bH=1)=gXa)qbU5ZQt{a&M)i(l0etOP`WKdR#e`hGEp4eL@<@ z?#hMo?>zRW^om9d^Td0P%O#J*+`41`<+*F{{<EEg|QU1cz9B4ZwFpngmr zQbQW{kH|$I@~1)Zza^n-Ft%OiIK%b0BGL+dwuhKQcs?ulN9Day_(R@s;~Xn|+wy*+ zMsurIAaYleBc99OD<=ohX)dy6(I2_DH4r5`aV%k+K&JA(D$Voht>*K-g8XcDeOc*H zEQeW_In{*q4D#9sBXV)IR|AP@QXuO+0#J>gAJ1{`#vv=d{p~8x%N0wR3LLk8)BiM+ zymo6VUcp_0$0=~$f&LP&qtI`08oF?tjLMFa>kmDU+n7D;V!#`&Q(i8i4_zhlM4P?v zHgFM6oH0UIhy57KY*h+o?> z;pM{h#F;o5OAc|kB^=#0(l@OfdB*29ytTy3fp_$0vXPHFMZdg(%oTlU!~N#5^4A?D zZdM9s{vCOo>C{el*-$v|fDEM%WA!78z-(d+t)GdYOdG<7#L8BXI}4$g67^m;@{E&8 zE7a^Nk}2!S_hr#vvKxJlu4kea=kYa~{qpjJCw-$La4XXQ|B;!nY@|<|bDY>+^v12n zVR(Oz++|t%^i|sI9+duXCuh*sk2J@)cHqjvoG9-5{w zhq`0Dj3tlLg73d$&+MO6`oxiU+sQnqyQ94^*C8C+2a$W|KyI-&*Mhcv@|wO^dve0j zw7db!cs{?j<{D!i`!T2sWH|A*~5O|P3cVhD zW3T+R(Hm>xxaQ&cxuvEr(`g$v)91^RdA>g_VQ9CXdBi*qr{n1>7r0MC4PMl(!{KV8 zpVZ?FJUwT_xAa)~aM%lf=7nQA*N+PhWoz9=TqeKQ?UghWH#7W<-%#TuXtxOH2%Wt0lvgD*b#>;$_7uxTNV8154 zr}}5&KtJjN)#Ajvv?u3>aD>!IL>jrOp5>T%@o2wf?BRJB%3NA%^M8%bfFh826aH~> zdY3m&c498=#Y8*=wfULMN%uC$`bXpzYtt*C3;D_u8Q40I>;8HNq{MtL_{1-SUj*}@ zxo7$5&wYwtoFupY?|zQJg~s&X{6P+Jm<=Ny#!I5X19xsmU}-*c#;<0g^jsUP1u1fH$rd2X74HciO+hQ~^p!ULU(BJgMhx!UI$ zSpLI?cI1C=Z}CLMaf@)Q7wZ>W={s3yL+6|XDRa^r?iClo(2ie!P5*>k8|tuL^?fCM z8^ms!*3To2TSM_f#Q| z{DL{-W%tQ0@;Ax-UfFSOW&lp&#PYV)&e;zke$) z%<3GD_zld>;@8cIUl7XXJ6zV44@p6teuD}=cZDc(r_;m(u z@%S%{PLPymp6GKrj9yFJ!v$wx=qMY4nD=c*e((u7)`2S%vFiwP+xhv8N5{)_@~VT5 zMquX=>Tv&Npw-o4_B6&zRz2n{FVe!+n)R728TjR@PqcE&3$35Y99BUf3arM%7#BnDy|)eKuCX#`7JI|` zL?HFH0Tu3Lz_T%V;f=AP9qfhaY8_@T;dsUSJj2BCs$jotbnvD>j}|q9$diVUPvRcV z&uhOtyz0*WNan7cNQC}d1}2bO9Cd|0EHAwkxt+S&!S;uJ=eL)R3(fCtelRnw!@T*#i*^-4j-GM&Jhshl`s?&&O}b`@ z1Uarul+yn6Vhl)lNzEKHDPMF+%>_f{A8cxHnpilTI)v>(UJbB>1_=95LFU!&?l zf|U3X&y0sSITMg5<=9()teBi+g(O+kDqe1WAQ$PIDB<}=iR0&HG(9Yf>FG0Tt3e{E zKNx!_Nxyjs(&C*#s&Fi7_DG3ELwt~C$DE_dDsUI-2eGNPt{MHhYBOmX*2bPs#+YQ zM`OR%E36IDgN8kvRt3ZqI&$ECbH-`}&Px zPp;005$6n0tY9B%H6!l2u`aEmXMmdlhsZd-AN@c1UU6s1N`B>M9X8EsVv(?f&nkvCjpbm6>GaRW1* zBFTf_XYN&(44hJ&GimJfy>o0_nD0ftS>JW)|474@-eVGw3JRLV+gik6aXAB+Ww< z7(IhABD-*S@kpN~l56`=&3y$88`zaJa|* zEx}M}_^QG@#HN9$`$YqffFNvM6#~Cc%)gD~p_dLl7g-ly_JDoCJ;_rguy2^PkcMaIk93gSV`w^> zEK9@rJFG*Pm<4f*pEZE&!87_O=~+)In}?~a(G1^6-QSb?TshX#9j$n@){2{~Db;9B zjjtYk8+EL=v!=XxWiGP)m_KdHLGgO-cd6;ErVh2bBQpv&SYdOdwnd%hELnk&s?5Um zv0@AN;||rV_#8l9OPPm?_4BYWoE{er^lU0gUx#D4XyD5l2=cIdv$w=`U~gN3N>-2o zejCQ;=eoBHobDvn(H^pSwU>NaO+Tk++}AE?EXO9hNsBS=GO%17Y3JZ6Q`49k-AE+| zCc29sH9Xe`4W+o0pG;ipB4q;|#lB@jDP7Z5q$~5KqgA5)%SUpUXC10l$+s{s`8Sza zla2gkZ4*D4mBr6t&))GM>HJfaIYm;DiKC`V9>>pw-ShR-Pjs`czGo!>l816|y zxXeDxY&Ch0pM3s4@;T85G5bk_j@y`bGn1KFjYHt!&*v~X7ku%q+?E^dudx$7^jgMnBi%-dgItU zo!&2e-nRdwPDgFBEuXjV(PRu~rDNg@3$|BE$9|V|vLqH9+R0p#@HBkOXTC$a1^$Wb zBd&ZF>sMRwdO#YIhgwkQEbE0@dY_Kxvq>EzjQ^*;o5mhk))iIk-ygz^yno3N9pJMR z$!BO4Sw}u+q2z>*yd_V3j-IL)EQonc&zXF($o1%#NK7C9-kWFNLO;L_DHr7Tx z%Fv6Hb--Y1UNJja-};e@**C24+Rltdj~r6%}1 z7b{QXBJNBse2$V|9B+loKUS>YO@4STS;jrgww}!Ac>sM%no^7OBG2;aKDLuc|HILk=PB~t|V!qINOZ!>*uI8Cn8m5*QaNS&Qr>gySlfJ#_=*D(KvMZT` zeDlnqt$kB1|2mo-YTYoOu4&(XcE!KVqo_{R zl9|!I^FmIPH|}3kqLzj=zEE-^1p;dNpq1KCEtt7B^l* z;BDUsGzldi`IG)CeDzf5aNfoo>XpnWX{p7tAIzFKtA#!HI7cVa3uXj!K9}>oCCCK* zOoVMR^Pb;vEyy~Po|?)&t^qI4GNOJH1Cp*8kg~~yDU0dLScQJx+*?*KQ1{{*Z~I#M zE1oexRo;XN+ymF<*W4zu7w`+$o2`xbc+r4>^+pUEM%|(g*M`(_-aD{YMoZ3-YtAx1 z3@FR`WCY(o%3#8^czQhsWaAgtY&~{zy>>4XtEOjS&;+j8&a>ZTHS3duGg03?3!{#( z2KJVo-9|DT+*_8eNY1f6dqY|Cy)h{hi@25?=fzCf5@du9vv-#J=Ue>$rGA-+b;w3X zuK#W|&%(pS%%!fHg;q-HP8Mp5Ls*k#ZFYTf7QlMsfBU!pUQg{jWKR(1m+AD>?x7<0 zt`h$Pp0d+Jfrk%SA2HgYx~2r0^dkdC{wveKvAT$Uh*28)8-!rQFAWOTX<$!HIQl8a z!K=}Doxy&KylBi?7mbS7=>yC0t((?D-)#%}e^190e`aRV(<*3RE?O+IB8=mQ%M;G+ z@yzXnpOo-wB2y!LCHJbIIBa58W&=MdwU50183jHzvqMSh!T+r#jm*HFdpii*4lx(A z30d|)4OXuX!NJ|ZFf5HGOGxJ7F#QL|(aY(tEojIwJ$11K_D$(G$g%Hp4{~UQWGs^{ z$oNd}0**V6{5kK(z~zy~_@Nrt?@%*r9hvUa!#_lt`dgamWCKHVVO=3n8e; zdCZ=#{y(A+MUJOkbTs=T$?m_QXVYN%ZLPH+cr1JP3I@FB?b(*Oro3L`Yx5YwqH&eX&ZnvD#ksNthsjyqq&HgHF3yz;)6ru$*Of~- zPkNE(;TkR9^8@N=xTfouhX{HzUOttF4tKp}LfPgLX!eoe_gY9z_K&o;c}d5br=SGQgOp;gh z>Rq`hNnXr0N{!(OQa;KDrQLk7_`V8b(tWV&tqRj~l=z^~!ihBjpHQ+O2|AR64vABA zm@&$TWw(szIM|4}9M`_JHDY87=HAa`A3OOE1O1!aZe`)s4EncL&%)IOE;G_g~k9&C_j9}}fGElHaFW>#jGBx(N6BweF@a9QIE+jSq9zp0>F>_fK5 z2U!{&rp?o0*`NsgY@|c~$;_e*;`p1*{WZtFN#p59OE$cW&43lX=;Oq3C;J9_e9vX0 z+JkJgo==W?8vSOq3iZFs6zVQb?bIXhku%_*J0J3E8lyxzn5d;BNuS9^G0!(j=^%r2 ztww$@i&+yk6?TqQq1j&gBetgp*Fw%M-t2AUIKSyCvm!V@jHgy#>KOUTXB@{r7|4bh zF}pg)-j3u9j*|Zlqo3_fj+c(vC`aDmE%Qxpj8UlH&||C0UWIyi5`71q?bME03Uzu7 zvLH`P^1a9?R)3QmrQcS|X9lV6sX}(R3JsmfI9&3ee+siCvX(qgRaYh9S0&C(Q>b5jH)7KqdPh?CIAWmAP&*41 zdG9RX+>yLK3+^Mb5ud404_aZTzR7EKlz*Q=|HxYj3Ux#FU#!_e{?%|$@}DG0nV3T| z_2xm*y;mY#--zC@^wsR#2%6?x6EyI_p%FS^sazq)__iHlGl)A?uer?ZkYL`%`KX@tBg_n6evGm$v{mXRL zL*hpHiE2UiEi^#JuTwTqh@4;C_aC;P3Pk zzr{7~6)Ud%Wbd4g8F|;)6UTkq0rG>V^XL;fUnz>V{!)Ffj})dTuzIf@3ai;eQA&Y? zm3Al|WRt7MLU5+@0Q7he1P?N4XIh3pTP+0rr}22+(#Po(xo++q`Zv{M<9hZ8Y~p(T z6!#2yoJUWjV_!0}g11_5lXK^Q#a0B;e{kgb57@=|HJW4eH+nIua=BOC)>snG_{sd4 ze$w-YN>Vs~Mh#NH|6P$Jne6ePwgNY1(?4=MvnL8Q`0)98^Z_fDuKj?@ zR?es6eWX^3uiP)~DaTDsr1Cp&i73I|K592by%jj}LV*USi=^p!dujxBxEMy3k#p(w zLe5>uAt*a_0F>DpjCG5~NRG!j1390s?vWJkMJ1x7PdbH*2{>CJEureO>1| z=lssz3g)b7AbLCq#4$hq{93#w9hmd>(WAvKJpya!p*q0YOKr|? z{I;NoIpKftJ}=yYrL1W@J;~gTXN}Nka#ZK7$l%#5#26=~h8~iSPZGqxyh#Qn9+bE2 z)jVFpoS-B%-fwupsj(*(1$n~aN1c{WI+QKPGr8Yl>UKn+Rx@hncHo*{WI|pgGqo() z1KdaLLDp-BE-+KunzhYStexJ?K;^vl1R3W`9PDrW3w z9K9HBgq3kDp&MDtBPI-Cyjs;f3q#vxVy9Oo6r7{4mq!l%5PN~1^sT#1{mQ9!8g&@= zX2y%L#spb&I9_zI2c=7_L8j>vrBs&$8O#2}lVd8pHmgy=o3Zo2P)jdm7#8saeL1UCi$)E@gZ_OrNILWKUc1 ze%_XehhH+Gr{4bi1(|4`OHEA!<2yOV;9!MjGx^*n)Qe0Yqx-x6|Hm`>T&^XvRu{@r zC+dH3KDPch)_Rs^qhIC5@_QV0$_Dr&upRa6o}^%uQw~nfb(8hC*Ba12XMQ$p+w03@@;Hr0 zQ?dMFBuacuMW@x|Xo~8}{E5Xft`E7J?opU9ITZtHQGc+ho0Q<=>(!z^N>CJ5c231^ zSP}8gS+3v8lczoW(PDZOf@0`joS%&@b85-@)zlo|-2b~yQE2@x1t*I*v%1SgW}GRO z-Q>S+4v(fc2mOA|Sdmbm6xRfDQvT$yg2|nc>zop6#g+tj@u~SoQtxpVYDXmg2~WZD znpSM+dWAd`SOK6 zwqMHW@w_JImk-e=x~_|~^Zz4_s0a6OWEArT3;u3OZR2@r8OoY1vsXCu)8mdy8rrd5 z-RhpR47vSB&ir9c=b*=o&=hq4n2l>{XKA`GU(`xJq&<$pkM^8-F8T;fbR!x4f;tWj zeNo2{g=_6upJ%S!xVBOb*DREME0{kY<@w@CDozwwG3q`!&3Q#K|Gh8%sU3x*nPlD> z2YTLYBBhdxWED9n(?#;Cc^1Ug%E8_Nj#9(3K&)p2v132`231oLqO?L0Qb#mxi=<}T z09ZOiK@O#$j63V_DUBqT{=Xv|`r+`0D45AZm17O@J=D^&pipYB^+$&R%(<#?o{n7M zC-$vYarXYgZ1TCAqtPjW+*S=K&DQ*Z7N z@57{w6h!s3BJ4&(sY>7EzB)fRI&X$k)(C?#kSc|==41Wl{u?jTU}r7<`$6|CXYFu_f-sa469|M?nYNBX!?h~=Yjb0 zBnoR8Q|q0z!fRbaNysP?bp-V;UXfe;l7c?T*;p1|PnK*ckkee(b#gaj@(S{6&B+(1 zxXH?ktj{}9U$RFO9N(s(bVxRyY<7|y`j-vo{r0X^6#TuYqsQyxKfqZ6>3ue6nlBPs zvfgn#1)igWr|-%Fh1q-pF$j=jZQ@w8GZKQF^Z|mZUnqP;xzXFQzYfMm8$! zXe`-nsA2HQA6ptnVc+T$6lG;&_}d0D=175*t?7>j{JC2;r;`28#^5iUN%1U_s}bag zS=YAfN)L`iD~@Nl%Z719Vo3Fc!vykl6D>fw986Akl^)ZJq;>=H)J@2ZHfK$`d^VoV zca-}vHksw_kKU8GzdcOBq@UUJ_oydBHj9R3qo;KRFt)FUSSopx$Djn^+IzNmcqpZ!X7qNd-M8(yVAO z)=5^(vB{?30F<~Ih22xQ?=9eZzvv>~zl!DW=YCic!F*s|3WmJS#>cvi<=Vr1X_xDd zDcm=D=BFUDi4~PMILT?pVyXGb4-0ovdt@;AKjst9-Tuiymwe{zu!>QrhJ$jiJ8kQF5{eB9XZ}6(xAxW~x8z-?VJg|!TUy;?Q z>$fQ#KT?XR-5D?I$t4}U7LFq$47j-?9mBrZpgKsMfYM5gR#I1qyj8Du8OT3ogPkc} zI=xmRe^VIBttBt>ki6b<8;Tyq$Vl>NEvZ*nvAU6ZM(J3+g8tEE;$^5kHKBUw@O^_3 zb=){hH`>N}W4sjB=lp+a80>@TmssSB{ZQaF|kmsrqEAP6Kmuwb}HH(bc z$?NvKB+mv5$Zt|_uJCC%e2Ws`RE8YWL;B46CrITD?uf2NJ-#Ti41+S@z})C4CzTf+1K&XIK~}s8inCacj~)s zc!0F6^qao5Pab|y!lxm9ll?jWeG`ag9f_t(J0S*>(*tD(@m-B0A2EL-!6S+JGhXirH=Yd_Ex2#z}j#WV| zC-QW06**_ZvzOESF!Wnu!1`$Z+%ELneH$kiFSw&PN{iDm)P?j(=b6KXGvNvHiuYR& z`j5~1%Y?r3$dk6G|17Wb_9727<^AUCXv7#D{lr@+G@j(7l%=SzSBgHNSLpjZBNNLf z*)aA(g4A{Lz_IPr%$jb1`=xYLT16k{c?aa(d@?jU!*T100Y`bAGglNNhdx{H={Nn@ z5X!k410tGGFYg6?gm+S>^0yj22a|(i{eRpN>eDfYsZ%>%u02y?!d@-fjApN46uDh1 z*F_?~&mPOc@8S3sXheSX4D@&BnfX<${G6`h8C!>o9Sm4Eh5DYnKlh)Gl{(bZTnj=bF(ns9 zf8OTPl}Ip`XC0+b|uCXOSm870*7J67HYL{e{v8 zd}aokF~4}$B9^(RJKo!cqhBNTWhSKKZ4=H>{f?Cbylz(}P%~|x0Xve?akeej9e-}} zZ592H$n7p>|A+kD=X@J_%}fwIea4@xr#Eb4Bl@38$L?;-5$MC#b0T|SYHDI+8Zc}c z^Fh`MHP>V1!Xyd&v!S?OtQ=oSJ<8HL@*?zB2$Q|$mG1w1CrObT99mO>YIH3$&pS@y0%GEHRY3> z<|vcrZd{NuteG}BxnZy5i=E4*s56@-D}tA$e0lOS`SG3&Nh9qBr(7I(A$h~hnaOuI z$4ZGs^c1`qD@ibC*rk2UO*Oi(M{S~a)Z{8;60It@KlH$w%Ur)?94#%CXcMhO zqX{bXXs)8pA8S8@`P^e_(-Sx%XvnN8>@8aW=Bn(QuKaq z!To!|agh4LW1sAIJlepZJIlXPgkdH@+mL@GmWTyf;A`B z;=Vev*3{I9;cl#fJvYL=qv3z%Ia-X!K>4v`8EcSLXI&#Ui{63zsGrDQ@((|9i4LsI zvu>xmn~p~>(-AU^yd(d9HJBcOx3duai#4JO>^+lbJi+sbS3GO_`P6V2!P?rR4BQ`+ z!CqQAy2NB)G@l#yj+#BqGEkNMkun>&&!us0Har7&lQK~Ej*IB;ImwSNu3|0YD#KU0 zN#21blF_J<^kiT5YK&SQ{PdQ&SJcvgjNBnP8WI5rm5`S;4FzBT}5+EB?*JvrQSUk8C6Fq?>;!lGkWA+iB-#4 z7YF&Z-9;+pJIm(CB3VO^TBBQ`oS`nk@Q`BJZzz;@T?(X6WBTT#70RAlHreY{B(}K< z6k3bqpGE9NC~Y!vK%unKu^+IZP}<}cigtnm_dh6bxV$|=J}I#6G3yHS*s!G1r-J%( zBO(?5ovAS84D-%kHmN*90sXf^3Gq^(^qT_doKPfNE(IWOus=pJKPf&>K5;y2!Ulgd z=^BWLqXCHP?~nIc0VrKJ2-UUzD0?LkZ6C7Vxh?>Q9+Q8h4t~h10Muc9X!XqieNq_81qD~$A7-w6MZ~WxTdCUM9 zILo$AP3^W2dX1bUd*~aDi-XA-DyStlPmf>6qTrB8Kk2biP%*D>yOTL2^R|ktjWjew z!}CKlCasP}ZT=~`7KP)7sU6pbeB!Za+-5#r4fL+c(PL~A=6a9xIJlRyf3KN$vuE>t zD4$cCen}tc$J?Dcb6+E|ZF(y1>?8Z6BU|`4X9Vk8uwt|YONORmeFY1()>83r9ri7L zrg9dBnoA=r_{u(pIW+|r@>4NA%Ys!g7JRS3{y6(BD?U+Uj(y+{tf6=QmJLYa*&Gai^&8%Jx_GVsKVBu>X{=gYx>IlTSrJ;KN92mY?acuy5B6q2w$o_hZ zU1XsW=;aY(rS36v#mK8&PSh4Xr*{ne7E7~~kdLS32s^lWji+%8s^r|*c zd#M_k$mu!Qv4LJ;Q?2OV&x$>)DQvl5#r%8pHrPcy$FVt>$J%~l{@mn|IXK!i2cgc? zbUf=O$A`H~-c+*#&P?;^Bbz7)2zM>5yU&pG5PjMTUA<~--pLdmaX z2mA8meA^dG^l6*etuL0h3I%6j6zH(Y4(@jq@LI1xzdzJ2YLh4WM$|Q}Xp^(;xW-!2 z6NAr9=4|c+YEbpz_h!^5AK8zdp9u=sA0vZ&%_bEdDA4nu0&DqCY^egk!qnB?K z`|<3T?TNyucGTM7bL;w%0nQ`GxQrU8>@)7QM8S*eZp5!>{MDA6%5&!YW%QVMjWv_y z>_K*9Pn2tGq#I{fE9h})Ai2imC^TIfg<2`pgd~TU*ns`E{4~s8U_oXF3)1GZCee=b z&2=rvi{jk-u2lMHTJU@bXOex%D(f zaUQljHC*_5e~nJVdnMV%0T${yat(h=)jrh8KIOmAPj2bFFOsI~SIAIoKU-#f$n@tg6n}pJ+vaFV_;+)`LA($RsOnb>M4! zwBpiKYB}<~e7%{`Az-s2<^!dOq2wl^_mUgBHBb3E&YbMjvs?0`1@6hG z7tBts!L^&myc=i$|o-+kZEL1)n?SAO_7xpVtEDK#d2 zOty?Kl`^V1=YygXP0$S+E~R2pZNu4Eoh)-j87 zhCv2s4bpXQf|#cpr2O4D>CIVJyN|Jwc+4OzwkZ*7@WAnr*8l`J-Duf!`MlF1J#_QfdOCOCeG!53$ z8%hVuSuIvZ=ul&m7RL&-_^sqwbNqj2K+e3((4j{Y9qO#qqTj#aXy29dGv1t6OxNK{ zNqSm$3d7LP;b`?M9Org%Mp(yuMMux+_S8y@CjY~FPT6woJ#98(?KJ~3qsZipFyYY` z)`ggJW_eP(it{PGa;P)LTGXQ)o-G57a9U+XZ!L37o-v;C8otus|tmia~qj&XRnF!yXfdOALAScuRFV9#q z%t^=yN*ejLlmXqEQP0j(e!ni35j<->NGpLq<`NkBnS1_=BAG!x@Aa?%OjyD5 z(ruL<8R#bI2Nm{NcRG7y4rIJx%VEhIQPFAC^tSu~=&Uz2Z6L1{syZJaUb~bt5myJ?10z zPP@zWhArjR-`=vblS+!c?Qyx49hPYAF_&kU;s*BEI^8B|C414py|Jx`$-mqR0bZFN7S?|c}R)!j8B`Vdt&<_YW*GZ#IAdu@UFz!M%DwS*VAFf z3LXBQ%=gkmhxskcs58oh3*qF>gP7ZICmY8cKZN_@kwxSSoHMa~DRs9hX2S6+wQYYZ zG|&CXf>0MRX{kcfhQ6j1?Cdmn9xtEU7-bh{OskYN%f{A+1dq*9zN3ngJJd1u@kCD( z*_{KP2so@lLBqw^U7*95<2u}MqBdfV4t{&cGfrWhz`)OF9(x+Bzu9`4&|hPQ*P%?* zKc9)IE$OSepKN-Uhd39Rg+b(XG*ftudMPwLsf{?a1K$hvwr=^GrQPpDxvn-#(9r}r z{qm4FbvMi77Mv%zq(4(9%IJ2A%Klt}HGv5R2 zr#Bj~ZZeK_-7VCy+(zAE)*BMXl4D$(iK^t^UF&Dz%4D*!aSDykOogTl-_OS{3eE9X zyhdbJ4quO#O(o6JkDlqh{~VI?pUsloJW<434dFRtdXXAAFVtAaI@5jn3w=JxIM4gI zVJkPPIN->41CAEyF^k3m2D`$Jj`$J8n?-R~5?x&Wo zPYE1ZYLELp6gV4YhueevF{TppkS65Oih^Kae!uvB05)IMqdsHTl(N)aueJpT67*k>k$K5nlqmM48S-9Q^P$F zLmkO3au0m|I2suh^>93|hf=M_vwr6hxFrp?%H%3NIakO$dHlRIbmH0Dt9~wA{!kCG zUM?1X&Or|M?1lH4Q}od0a2z?iXi7&5#Bo(v%SzL}h5 zr$7vh48Yh~L0Gvt5C=8~;K4G^m37tQY(8rRS^sf_di)!zM?rZ#J@3=7`Jx4nn2&hp zTTme)4L8=NVf#tyyB9N0p3FRfI*lt2@as7_xLd!mjJf0`&7++qWt^A13Gk7?wr=7& zM}bvaI2*^>PXS8c`xXWMx?U`^_tX30Z4frFW-=r&7^%yshq#IQ`^Tx>`$~@$)0oHc zT3IWT5t*?C)%U02VAy%gJ!pYvW3r6)=h4YK4Gzg<7@u2_?wpHTNx7)KB^RH%e}cKT ztAtJRmO7_hL|Li1bZg)()+SBm6!Y5>QS|nxXpe%Yye^q`@MWL)uh2j&-WZ7E^#jp) zQ2_V&AnLjW;VEP2w@Xpz*M~KiMO$!oksc54QCDb@1(*4GP5Me*U)D;F@3J5;kF^jB zwWz1$qF-hXY{PRAW@D`)oG~NGO@82Jv_$E^XtR)4Hg1z=d9KP>;U7tf!a&l=JBC()RER?i$&kKLc6ai%3T z{QFpNHix=WmQ>uTnMR*^`f@9B(PIGpRohYX=_I*?Nx5+CmxDpnuRHqNC`%F!%EE#} zGIWPo4qT>ZnV!Ab2<|}@J@MB|6>CQ-*e)ocu1n_q0nhhk=(Tf_e4I0NeY-^9`~Wkq z4>n_KGBwM2{yw5L!}}L?S^e2poSTJ;Q|L9rbM4X3)b~Be^?yvE*}(m83}ePCa$jr6 z$+cuGtHRvKu2h0NjW$Y753@u}rT0;5v)qdz``$^7);?+s{o4~yo~TiAi5Cv!Yhk^n zMOsfSG#wTr@(*K1ypGyyW<+_KG5HU@cj9?|KSPZap7WO<$RyYBzq-P2K5=fmNfw?Q zr9L|M!{VO`&7Zdl&134s7JO7_KJQj&A~WJ-c^dUAQ_Qkw*deLqa8x|28>My)vUy`Y z(SUXP!<-ce*v96Pa}zip z=cB{%wVV%NzdLzZ1j7E+p@B~XCbgl4z+!qXonvi&JZC6&n_%c5sS0^JuVG?j)@zxTUBlQT=9xyEbb!}$7bs8K39nq+<%lbk18*>|K_F1awD z-|U5A>JokbSB05tRq(Q^@nDlDs&1xs!zbz-Pv<%4I(4BL>)&kCQOCxJ^8wWIuVKQ{ znT%Z*sE4qZ*NA70g{;57Jxfma0dp_rciQ{R+1OL>Yfxxf{j?!)5B&pq=BPMd@jtpC z|IL+6_~0xrISX9oIP1eF>6_Dzypq2ax}yyxggS$Js4F*lV-zCPspuU|cK)2J)SK}~ zqN$&lQkGsln^UNhpN;bioaK9oKQfHmS=S>xzZRz8SEU@xndB;Yh9W8G%srwTYgNt2 z@BC$jrj?U)UtA#NlBws#*Xgz}6;8jcFe_Z7J-M)rBm8hu8-?{fENFAzit(xSrP1mF zxqZP8`iv+v)U&2khcm3yMY#F(kNDK}MZ<^DSRTMREnh2VQX0yOPzCBe8HDChktjbZ z6@l60aTby5vHX$0o6_gkL|wvtsd(?hdJ`H-vkrxVdem`uBfsOHiu*muF%6~P^rK?g z^uV7z^eBwEpUU`Tg-a^^qp$yxUNr}y+UrR4DV2&bD%PFqHk1Wz^F=Y&5BWyUC$nCy znwf*9Z{4MR#vf_j$`2b?L}3PNY*RK^5&4wbyb}tg+;o3r)gl+^&beULgmnwa_vQT& zH}0wGiS*b0Mt{|v*_e^wB(=%kt*P#Z6L;yiTgrl4z4DCe%r6e>59Isk6DaS)s%zS^r!_9l*ELuiQ@m>$k2lbZN1q2hmq|4(AFh z^E%I`e|KX?**G&_)=(dF|MN)TQ3~o;rvL2KCUS!QvyEp5V2Xmejf@HHb=i1xzM*7K zA@^4}2$AHxEX%0}x-FX;YV{<&AWzODkTYf9ATOD*gZ$?EgNu`qddjn~im@h37{88{A3Ni*P|qLzbi z8pc+ouEG1pvaVmD93MwNtn<{^u0?&leO8o?Y$#i)g|X+gFX~o}g3qK>6pyyz{&)7t z$P2G}HVBDZqHy3SdC!`B|NR=vOX}+_@$p6Pa#0w^dab1%XRfz8%jGdP>B5?IdM(z1 zO%^QfPCmD%ql|Pe7N-g1DBDCMkY}^GT)zP)8i`g{D3@yZVR>)Xo)=M%a!WSW-)SOK z+WnDzXMJJ(LjQN34JM7CF5XgiIhC6)GT)E6IBUiGEXXCldEk8`iMn1Ot#YYvI3x-W zf2MFAiXJ$b^<~nge7UliuYZ%A?_ugHeq$eFj)RQ*@<;Y3`JvAw@}!-4KM!Kvwpjyd zTv#ZV$w7DQPoCF_HRkErs5Hb?VmlSef^z;yIgZpQne zDY?ZLR`h%2B*mY8%jb5!^lae%5XbuRaQbC!Z!BeA{SnEHxv6EnWzTD?o?jHkxuj&?@3ACceJ_o5f%qBkXIA6pX zzu(DJBsf@MEaf7uvkGNJM_=@`(AVCQg2lYf%^o(A@i7H5c~t-gg8X<<3Tk(xPU4Hk zlDQ&ZOyq)-L!&UIANyPHvT@*ALm646NT!hQzQSI>`1TeIcD165wT3L??{#K4bt zd!d8{UGLEUoxj)6m(&lfKrgE1QJC}(KNs?+lUp^CYajBY5%)=*54l3di#?mzw~BI- z`x$xiy^=r5&F6KPk;+*v6X<^=%(onI|?BcWPpomiuDL$S6!Df9ijVT<83F zX}3p-cL>A9U;`Zd(lKF~4VACP%I-5tG^6ir5_!XPa|V)%Y^=A%iyt|%wz1TYb2Z|` zde$Tvql3uNw6=O+a9k)>vHseu1AS-6odumSNp%IalgpD&Ni$;oxpb)NDl~POn>V@T zflFiv;>H=U?P@xE@;2t!vC_S&inX0kOy6Wc+HdkTgB6;5Q=A;#;sy)r&M$7$gHfN3 zCK{fbsQ-1Z7UTcWP+Vl4`1ob&cCEAFYX5kdQqrA1tkh?kM_t7c8F)jEX}d>^ykF>s zG7jMgwIyIjL^?|F_xkbIe)%|xdVjfLP@bZXD*2|b=Zj(E+~%EQYV2$ij)#@$ACZuO zoM;>FmZiSiL^n9L4~6w#`f*3oKO)hFF64K-cer9TA73%Rh=b2E@MI3_0rX4ltz;cu z8A`7g12(ltM`2BcX6uz0`SZgaOKWNo)X#vryVA*y+u)ZMCq4U<4zsYWw^eNmxF2U=zkQkRXqo6#>$7C-QSn!M6o*77ws$;mp| zpzw~B2V`LCW|Bh@avYb^@qVcdiJmc%Hj`deueB&S$B3v{a(2IpG2?igD5$U3VVo9@ z76a$iGq9|sLgT(XMmAMd(!W*4&VR+Tu2){CXeR6FZ^5bPVdC4&!wV3WU7gUZ-aUI`ICCyiCs2 z(GBjrK1;a1&i18eDBov?2C>qTI%rin(-lm1rJxgix?L2Sj@J{Uu&oEeABJJ|Sk5OG zb6xl;Gw{ZEsc0Si1WGkY}jxoLAp>o z?Z?0{l(|d4?6dT1_El&mP~WiTM6M&X7R!DmAep?%r_c0BpBX1@FHsM)e;B&dp+EJC zbZT=dG}Y?GN$z?jdM?-EiiX@P@52YZ$rsO|5A|0M6qv{xKB50=opf@O#n{Hrr7iV2 zE)CQor=tG12veIqnhs*;zg?av++_mjqXv-V5gA@aQE zwOG8DZ>XDM2v?z2Vi;ykrRNy$t0Vlq()oEE?#|xd{7|f4MgQ7S+@HxO zj_p9-x6|~a|0f(bzZmfM1oFtRp=n;M96sre*wbNH$Ir#qfnHzXHdHwlE7SQt+m_Ix z3Ui=alc}?2wV~#e7`ac*+Ct9ypRoo^c%1>2qYcZb+k21q!(!G0;>oeD;5uz~oO-zT z;^f&M4{V^G=FkxK)p(yIaCY&<6zVPZal^U^;i%Nf0Q0|$7d;f3_G4mX&R)U`MLo7WSzZka{ z#z}fpC0@u$Gp@}=2m(wWaQm5w0{-gl* zy1!5M+i@fLYe%<~^$%0dPD^RjY3me+PNyWWQ`iAxhrah0C(qD2rj+%&m^{AC$xff& zs#6-hsnw}xxp~RT@4ZrbE1IMXTQ;&&2iK^MWu40>pK!f$PFmMZDV@3JT!RY-<(hwj zJYX%NP2~jf$chzTY8kvfW0u5?28kuld+>`<6z2>w<`I3Ss~M#F5~J+vVvrJ!2ANql zUY3+hkl#sWxt?v7!lwoq$614bEnN4U6&O99uhqvOFZrA$WN80fjFYL%^{lh^(YWsdGvMYuR_Mq{8Sa>>tliVQFvrGbGVJ z@HusZkI;j9vI@h=zV`}d{Hjhicn)IruqyZS4_b`P zCWCmM`~5E?=G0_eL2tz0Gfc4iM2+6X^s)cjfO{?I@1!(QXP>?8Ek-!*HzIBuV+Z5h zGVZknyN&4hg={d{#oW_I>KYmGo6l*R$(ht6CZuz{zGjRVK97&R%bHg|a*geb@F^f8 z`P+zLN$ht&HsVDs6SlX{#Ev-n{%vJH=@!3UMb6O3J#uFT$~~nfBRS?Ol8IiUGBDaB z16HoP!=KYJW@b8^hGxJqkLRt&=_ngX-k#I1QeyOq4TIDJ;N2}#hS$7Hh z9_UnqLyt~mra&!6GIV#4^CQ`%XCUZ-BisvPz{2b4GXN;$)YH@Bb z(@Az!E0%{Hi{&*L#-}BV#p{#;>am>D(^D6KU-zU(fNJv}N#9;54c2n5Y^ws=1@?%n zVw3sw#pSFvbAuvz<8H_MfczC_oRpCYGORXfKFKEfQN^-(0cZQ$D)6B{b^i^;a!pq( z_vYGUtCDk46YLOJ$0m(_{t*|20{tBVP>Q);wGRQf-i|X-ul?}4RsiPtvNk-~A4BNF zFs*GM9z62H`Q7xKULHuVr9j-%2Ev^0kEw40@bHj7b&=>DZ3;lI0f9KlT8Nya*K`ek z@=u)G9PN+AFX(rXNl$7^02;7Qp{`180Xu)zhUlA7m$R?W{o&(5kEhL17*vIfVn7u7 z%!o!DbC+-Ao=N;(f=t$khA5l1?ipJgh(VXYx{Mc-ISFmq?D~+Dftn*xK zL5|AwpZ202HQQ2uu0H$2qoQ%vpI#6HqS539Yf!1tSj^lpNxcPo`S>&4_4vWsMbRhn zUbCWc^Jx@ywOBV8!#*j2rw zsc65QJ?E#XILBV^05XiPnKvC~pI#BnUOiuQn5P7g1&QDci(Tpsc9CJWZi%0ZqDO=psyh7|1R}&Fm*S3NUk|p5ND-N zwH4=Qvrco2H51nRQZAEgEXAG*bGD=ttj}wyCs#Wc8_5aO;-7E1oCzI9O{f8^4W7+` z<}GvIDArYya?p&uppon^e1B%e@AWx27iPuHpj;fB%U=E~D*|g%)3LLU?7HJ1Tka`k zYNWHgUFjl)aUPOLUDPV0=-tp*EjmvhdD~hof5m%B%OjqWq-rANH#^IP9Vp*-#mmpC3@OSU2K!1oLL+;n;H>g z?2x*KOk}7{`cu<3K1TbDgy1nuzd6vyOq-srJW-Za@Un3Lc0J&1tfL>+UZh8L$pCs0`Jst(0JNNu#5(FwkxTy3D*#o7`l0PUfBYIt zUC12HmcHUWUzN3#73}qpVZ70bzCJF<8nPty6ItQ6pcFXIrGTJ%U$X`a;=#^MX6u{DUnagw8l0<6j@-1h)1H-AlTwy%O<8wyO;T0&DxKCQ-%kGb zYo(Oc$6Y#?e7!iSZJClOz1N&i(mYH*7doq6^7sCe&b`&_Noo~XCS_#6gQPwUOtQih zD;s_qWNrvOL!Yo`)YK$ZK2wu%cZ`5%$JPHBq)8^vZyyb!Y(Ouo-DdHk&QtE1SaIGI zBdgaMU3^UPli%MxEMA(h_mU7FBWqe4 zW%lk^>Kw;OrXgO=d^5>21!r5|DzUV`n*1H-y6B}a>AjMBD|NMlRLFm$M1TYR9*k-{ zcT?dv^+F1r)CgL{=kcsKcZU)OBY7??=2>qMHMx1-a~rF|WQ`il$}lgit48=1CH)*! z*yE#yay9)eIcN2UuNggobA>1Pycg`%o#f1#LXFHH;n=7lo2b>oM%M6DpceJkYq7fv z&x0Z17+Z0K0#V*|A?*PyP*9eT1Fw0Qhji;Qhr1dk6x-6GBr@@Hw-_X;Rw zKvA**mH*4n1I*~ev)b`X^u+KnVnb#A-Jbor_C_>kKk8mbBmU)M9bOp`(#nLcM@@J& zhrR+lE7sGSs4+wKVmS4z7SN;G!ALJZYRpt&zwxC3gLp1{Rmz0%3r%oT8PW1K|NmJd zw!S0B_>|9e;T)ke`?ii5$gWE-R!s(4gPxjaGEgf%6GJ$QdX!vAd7cwZ{W39$XTVLD zGcb>AM@RPP{=P#`k+Gc5ZInSDPxkD1hEy?6owFem{rLB_DfDjO- z?imRFnhwt$8R*Hg<El;T3^!imtdDuZEcmMH_M<4AlHBW)s5ABh5l;^jJB~YK|z*fTov1vZpIK~D2 z@F29l6NGWD!FaNb`|<)ku5h1zs?($U4DRXcs7Kw)f_kIRBlR*h88=h2mTcn{dITjc z%SCbl>*D|9lBvjnY9IHbr#YxS)kmbchjd(|mJaF7r0!fFc{)!ePd)7DnOr0b=iA|k z#U8cE`rA=^%Q`&>rI!R@)rKHM_Xwh&WDr8i1fx!{9&2N%VL6bVoktmWT5Lhy2I~LS zNkgSn>g4i_b7?wRxsR!6{*BCmj-GEmxoFhp6Tb4ge7sHlrWE!IE_sM*gNsngYwnf4-`q!1%}h_?Z%nu$O)~evsa(;q*m{3&N&? zXzXrJW+qUNDE{64v>r=#MPuI&3qCSFJRF;bYmPj>F@A)R_Z%>Y*MoXifs@HJR_2)~ zD;Kj`@cleg%CO$v^5~+g%pUD3wOrfDlex_#rOJ<&Dz8iqAP?~4TA8t8lb)PzoJWKYzo{J`AjH;7kFZf`h zcD6|#zdt1Bf)C5*f#lYIsqwmsCr)~K!ZuWe^)bxPi&RKl$QeK8%SWs_>{3La-BKN# z&PSjIbIcmC^k3R&!gO*NF+z`l0VW*VmX3!nGq5@&3r!vWSGTqDvrN>O%zpVIvJP1a z&DZ5*z+w~{<#B~(iN5;wQD36}S|`%^d{<*mNzM*T=CvZ*+4Wrn&LuKN z8Ob?N+bY(=8d_5`!g*b;jHI`!qZw;hhX`Yxp_(oOYinlVd{8E4pJr`!BRv_I>n|lM zcs)d+srQgIN%A{2`FYK{tkA^#h?fn2ndK$@odaB1cj{-7Z7GRTo}bf%PF{$7L@$nV zN(`*d&+n8P=SM`KEAN?ct~$K!tiyxbI^6!EgRG^N=RIl@?=s^XuhEMl6Q;2a{W6s? zWpySJ7Spej*J;MX420ig?XnN~3-UvkV_B=eq0n#uN;9e(=h3PEHF}jS1(c*qI3jG4UWK{YC0?`)}m<(9j=k#Q8-Z( zEr$LVHyKYuOjxv%*M?l9l6B3!W7rEAnT4+N=wo_-KD2E!(PR+yDpSEvc2hB4DJ(KMbJWhd}9s&4s zG7!I?2cpb2`URg3KtJw>*Lu;XV6+~CzcOcLPW)&vHL|WnBlH$$i`>)DQcF!%p2dv~ zEJ$s~v-1be_-xBX`WnWriaFSMJQowWU#}nJErXND>6K|F8Ld3U@YYSr7b@jzZ3QA8 zaKC9oEvZHdyj`up_k{{fOb9~K(Lf}I1mj0|5bl=>LJ8(W;CrbxgnIGJF}ky#7{DAN zgp75;zZN`Wu3Y;_8g?<4p0gwkd$;mTzdV;bTP_Bl$c1`TE-IeNWxbsGf0Nv0QC3Tt zGu2zJzVnjsDQX$VTF-_mbJLBs5ZsOAimJaZV-Y=PIy2qF5d?jUwN}@AqiDvynIF{=8y>9$kNPmZCb@JdZSJ|1jTK z#<~S-4C@Y1AG&-lM%nW-x|f4~x0uK8$;I?JRs^qgm;FKX;r_yT-bf#rUFayka@?iw zYCDYGQY@=FD==xI0$U1-rP2X<5_kt9oadg2egU{$CIF3M0uVYd5NS8`_{5kR{5TpV z8RyH)(LM%Zv4qDJHqq(=4u&%u^bqg+>ZO- z=k!dtG|0kzYaX-O6AveO!CCEvnXh#i z`i=AY+yl2}>X2}renlUtiFk(f=hj2@oSO^(H%^f z$*((=COc@&MBeC3tc_s3drB4@xnGCzx(sKGXv@7hoN>!#6WKlT19P(yWmA8X+#YU{ zC$o%Fb)`|pdz)oNq!+R-t1!ET8lU!iQj(odEa!1NW?xXwHl|A9b7|yq$io^LI(fs8?u$hIrFujc~2+4pHQ;zQ3}mo4~6FH zNrh%+u|iX72JfZ+L)u>kwbj30yl|+yJCq8ZQ0i1^uSMO9*WKL}33WFJ)JyRsK;4@V z>aIxL4XF!G&boj9dFITVx6eJp(DsH9_TFDx*XLTRI6=B~(#qVnd~S;AlN}!?3+Yqc zkk{rr&&Zo7Y8V=+kC)cZb3CNnm ztfxlolZ)p%_MPXntIV3-!wmK28Mt>j9cK#Z#owB>>P8ms-*z(-k#)NbTvzX{`oB8b zfAz2*ldYw!eSx^$_QK=(q43#2AHc&|NDH%*=_`uFw8aZg&xJ6LE*UXC%!41)SR%}Y z@}1|NHJ?M+fAgOV7|#!_W0hWU)Y4E686(9r-ynYx<@Eh-(e=uHu{v!XeO8FfA_4T51!W4py7Mw z$x?6Hw63W%|B)|svb->5s0RC@sB7QI#FlF|Vt24mZjrycL=Esy3V+`pnW$5dT5g|w zdG^f{J^4B@dy^4cn2EPjnn>Tbxq>QQ7%`E0c@^s2mB}Z5agx^E3+2@_PaN1Eig(ny zC;ucbW^O2NDin%oxHmf2?$-3ejB)JG?m>UdM&!%RS;{cx ziC1IK`N7*Ev?i{sRy%W`9Ay6 z5A=5?=5(@>hqM04hBPmDM22FSn!a*gS?Dy;j9sfjkEAl*+|SA zOGHh5`1F_%JlJf+=Wkgk8`(_Gr4&jCE5OsOLQ#ode|29bzUDQN_1}u+@JI4@jmSj~ zHsYHi3stPF<;G0rBinmp(v1*w+e!|rZ#F*UHY_pX9 zJQEi1`E+|7f~@XFxOL=NuCJr4=v^pV26*Awp%7fiscLEhjG-f*F9j*{p?JX z8q-WZO)Zkx(cb8JF$7gy$TbQte&ri1j_HyyzKlw?&LMK-Z^_OHUYfn!J+h%gg=b!BI^hWVFj-&0oZhNxe z6k;t)J@dt8wFge{`uDlPyyLc6I8&#-T#YOgi}7AqoX;AXDH&fcWuo&uTiM*IM7q@X zAd4D`AwQX8bR-iuw$ziPN`+E^{+lnT=l_|)`6TlTyq{Xim8J!v?n)ohlbn}=jW}^B z3-{02$^N-TGH9|FTn2KVsWBq1SvJyEHI(RH$C4%u;wK_IZ857zObnnUKU7~ zyF*dfB^3XVjHB;4AC4nGNZ-|U6TI;H6#X1e8?j51g^x~FQmK5Aq}>~efQO-2yn^{? z@tNpa!&<&(=Zp5IC*Cy;MZZM)i44wy{%})yKe9-kTa(Y78-gKL^a1BNYqz8=S&l3e_eEEum?N|(3!@{!Mf^y3hO^rL_7I`WUx8_DJ4%)3A34d=Zfm{p4R zCF2VmM>Umyh61Tef6RugkJL#eZ_d{#Z)YpGP$1(po|w-0b542AGYzwGyEJnvFWJMT z7Ww}X>IN>1neNcQ-Bx5qrP z2WD!uzh^O{uoM0D=+D)ZK3sEM1F+j)3lq<^W1{FwNI!upsSbGQ9Do5ST2u_7w-C&D zIwnfyULcp0pvJ`{EoxJf9nSsc)VEq$PiA85mLSw1FW_97`OCg$bkW4gmn)9we>e~a z<8^pWZMQ*nGZxc}YVaRBD1HXwpzwwdq9WBa=%Vu*x0<(f%mIz2MaW z^t;rRVBY5_@w!Fcsu6Rj7n2L)UN9ru47(*!%z$&i+Gzn8Q-eBHuT=QumSAAF2=Sfj zh(?9oE(rkePM!gC^$zJBzu1>}67&8i)`}}edpOc;e@F~U2&IZiT zX>=WpV$1t&aoRIgpoZ zq=jK*8hVzYSGiZTY}YuU!cFGhOC0ixa>7%$aS|q)foFFgxgFdP&=#Lr7>*=e@svLhT&enKEFFJpbF3-!poCGg!8CF`0w zA(B7$Y%F~<;~(Q@SI!TOnGZhK9#<0l@u3zuq(}6D{ab?i2~je%jsp%}3_!Yt4$V2f zrc@?py+2aU7ujQfy#ORs)X~SIKJ$3ytlQpu?QLHO%Fyl$3IC)jc2_<2y_j!?>GCxMA zBIY|kp%36Td(;~qfG30L`ElSeHoB2lW$*s5ro6wqR-)2vEe`Za#XP>x!M3sTDV}-I z>jUvuLvB5T-W-|arhVvxx!)1jIB(3l7?1Y#*vEI%jD7p!Br?tcLmLF3lQABhAE&~q zp&9*J#>!`M%@sJl4*ZD6{o1LxTa!89wId{gHO}(k0dPGXkM&@FnKk?ElreJUnj?Om z48%6G789p)o}|y?|GzwAwGjbs3b*@)jnC#Awv1Y5c+q)|vChj7!-^vv3{?6Jwwad= z6I--2?)+S2nB-XA7_y_cL0gd5Rb9q#@%zp)#{7-JZaxca+$wh4aBRfak_V(2kB z(eNp8k=u&B0}UOY-ZY$Oa;ED!?M;I&<*&i#(W8sYcI`5ZHB>Z=I;%FiYnB^!^&VxY zwm8O6p-!%0wI)H99f*}%(e!DYrWY!aGPRdh2J}8E^C#)$^1)cS!yJjq_RJ>;N|3fA z5@g9bt<3wVlZEWj?7+U!XmXBE=%-_uA1!;X$4i$LakAs6PUgOjm90DD#mQYO8%D-S zu_f2YNWIwT;-waO=Ie{;tr`(cEiH~2)LO}9FMj7oP6)22LWiF0dGAJl9M-5W(O+~- zIr=B=Qej{cy%TOb!8<^O+e1|7yiJ8g0qiSmtwLyJB^rjPQ0JhM8LcXueyZd-Ly4tz zRk%@}ee>Ow7<@;GU$4lAuXVuj0ZKfk*UxB$5`QW<;pJCHT%;ZyTh$p8S~@eUfL@Rd zsZVWHz{d4@)*xy_Yw@*Q+!mqcUqekEZHCEdO z;o6}(hOAsxdD|jdr!v7)OS@n;m_A z0@OHFBN$H}1fg<${`oaMd46#0rD>_%QWtll=2Dh(D*H!E-{l%Sn7JVydIaa_u=yV6 zhGG18qr=NX+%I%XK)Ksw6`RsmB9k?umpV+YrRUngTG18qx}Eg6)t|NNdh|^Ft;dZ2 z_6#Ac(+r~i2G(qj^0og^x8R=YsDWOOoZ~l`bod#Yh8}OoFS57T$hxszEAoXw%!?jK z{=GJt_IUPPIMbu2AQiQ<>C4E!U+P57tPJ}Nxc9g^fc+P}(&2KB`GN=O!)QTH@l+Zn z?@Na(HNMZk=+~T|hH%bj{>RBf?oLNR$22%@Ps6@F{26D{Q2z`4d?xYl+*5q&<|1Q; zImw-Uj#59Og^cQGBYnRpW&SCZJdJ57PiCm3-i4;ps>2D;*H&geX(B6^yGVS7BN+~Rd0E+B&W75{+t$q_ z^`nCvT1>yVsm<7PWg`Q=spQ?wrgD6h1vc%c4#FB@|8dkGEG$sXKxQ$RY~n%IJZ~uQ z^C|NNjwoQ=-GUyQ7FhVYNNkv!w}o{8kNxaX^(YaS&K7{J1zzndp-;3~9x0e3#T;o{ za+0gx7D)9Z_Byh!Kh0l(o8uM8WY652?j;gGwopEVx>HWE}VVVt^I<_V1F7BokTL%Ln6o`5^eMH;xAQVBJj;*$2I#e(wXvfu5*cLLI6f zImVv!h`h@lQoRQ5_sBqv<>#)pKJ8q&(|R3eKIQ7GNEE9&oP@#2DwPGNMuk*6-a-_;Dl|Wq8iDA!k*0nhAzM%(`Gb>Af}C$I3YvUpgDx`!nCG zd^RfWqUKH==Pg;o&14WiI5I1Mf7cqbu)ALt*6hi~iqotUtY+^pb@}2j=7YV;!q5?{ z@qEfctqEE1YncuEPuW-yNp^tWHzR`ifc*TkE$hD@`&AU!^NRjR z^pJY`T!Fa`3T$yv;LG}AaqOjlV|fca8AuM88POg7G3VwKGo|fIp#$^BF1%x%jjZDX z*52-aEtJ{UO2n#F5j~2FB=V~QK3~W=9w?M+Mzcf(vR87u0y72|%e^*c*~GCq{VDSx zw(#7)!w(bZGry7Jz_^WmjN}-t5;@lT_#q{ZxmZ_Nm-_01Ij(;2x#EM4<9%_ng)dwh zaa^Q%BmJ2VZjd#&OYLzEUt@lhH>#!jpfS-;UQLd(jk7sM$FkPO8lY`;4Rv;A!@INJmpbi6j<3FbOz4@Dj4Xb3^)=z` zH4}z4rWUr4KBfHgF>=GFAJW%@ykqWn6V}F`0@&(P)Eh!e7J3j@6AjZZz-G;F*IV#v{#;F}1Ku zg4+v2NWA?08Yi6x zCCDe2M0wz%msOfrS;=$amKw3Ly&=!F&*G%lGoC3Noara4LR2jkHXLH^WMwDncS`26 zllur%K~6Z4Z%`t=q6)evDqMF~!Y^C}Tb_&4sxjMPoio(s`Mq!1FJ^9mCKH_SIN1SD z8!;m-!x2wsC~`xibnotM!s+1$ga6%1}XD~u+)wtyqgb~w%>46Z07l~@rZmUM0 zA3?A#t%mv`{rea2%so|&Yk|QS$$ekWRlar*eZLjdV5lPvWERBEjX^l_fxV2|f?>fw zn=S>QOa-!zyL1?FMEAce)Wx^ik12X&zGoeb`@nk#$sWGdWBUX4GrH^XfV^W*p5^*) zB9GW5f#ZP;<2*e!rTt%SbVdF>Fi8*3JIs`(hB4TYxg)-M3~xs!B%l2>7j!W3wTc?* z@tu3lX&u;8W5wEE1wA_W=*Uaa4{}91dag~wo!x1ubcNX!_fp~1hTdiVX-IWv4a|`_ zd-dt((KHR~zS7UTCD}xN_AO6;kABqRCZyvj_kp+g=YiMwedHQlgVRxY75iKUr{VBy zdfKc?!>$GSAI&(RoaFo-VRZ^>llh}s3NL;j|R9+WEoR!57nO(Gz!97@n7B#`IPCCVi%-b?-1-%i~;0{;VLenrK1T=NH$*9&hYIhU0(x{|Y8P&&vKt&`}s zI?17<+($BZrw)5<{{AeIo=43xYzx=iA|Jfuy0t9A2S=CCOQbQqy*v1z#7o0GkTCib zg|YWK9F@0)A<>3^PDw$RE-BdXivC}d$TnUv;oD#CfqG`66Me0cs%5h#POgy*#+VCP zP&QY|f>>J#AKX;l%;z3{p|c#=Uu34NmF&p!?54J}Q z;~tTF&e`n4A!~WZA{;Z{gyC0w7)}mg26j_=cjvJ0CDnvAb5n4%Y6@J7Q_ykqCHggS zzvsu^5YF-Oo@5!h-?D9zgYDcuZMf$s-5gcY--YLeCM{*>nD#PlxKh4}0`cR$CUMW%&5PG+F?(5p==VDy8*}f_$Ab({zVynS1bLIXAldJa8+mS&*z z37$WPr(@bnh5O}^%ta#el~dlr{pl5j`}-g4d;XLlVG5lLy-z>k`bo0vG_xdp^inCs z8Na7FVbBux&X?u-aguChP0szd$S-yZ#;w_$yZNEpz;pf$@|D%~IK_ItOREGZ4LmQe zV%En$9rj;kKk$Qe*xXJ>JDyQp9`QU%?s|0>dg&D@+|S)7XK-ENo=KiC!Gb1_e4)w@N^#NeNI)Pk^JHo@*8R6RFECtdN0fDV!g@)A3?`IzCTKgAX<09b`V! ztQ78d3i-a4lP}0oxDVXJEX<#=GOtp+TnT00z|16Ba+jXTGgatc%(XRLg?g!E{$rIW z|5b&O}>?iDD;ui5;P5?@^)@ zly^oYTNTbUR$}60zNcGUleJ15pAd|D^VHNu_}six z&prW`>3ZzGmWS9B7|`{V}|E4awHOA~!gJ_pG79J$#YEJ&F0(ZONoQ?R7-r zwv<%A9t?n zbD7`SPmRHkwYWw7q`F!MH?GwS1NHQ4*CTWquZveYwml>hl19(AxBv0~>A0;{xI3I9 z-^u%Rl8lqJo*Mrc@{A{2$dQ+=C3L@1dN40IrJ{=*>Zg>?RV^^KKRs(3F`Ks(dnQ|( zBj>{*uYAy%K7Yf%__Cfej6JepD0MUp z;CaG5P=n-T4c2#HegoI9DO<@elG$_pn1UA@O{imU;=GiDqvP3^SLG|7a4xzslRbSr zD{p+*TsAO&F4l|~8CeCB+oI1#x zSQ9FQv;T2P3aSUD;P}22%;#GF`*t=ypUFlB*9|o})YCO{(2#5X{cKdt3D`$|HqDWy?+m2|z?UQS#wO9e8XEf$u@Al|EW?<^4h+5&}B zyz#a-`zMgaXAMk%j6)QJ#E%pFD!X>IqjDuan+Ng|M>(t7=A>i|8hp% z&CV#P;tZSPO1$Gapq?Ey=Nt54UBmwNd^K8d9_kyU#sdpAI9qIcwNsp$} z*;Bq>k8S1Xr_hYvu-xxXo0J9z?pJfmrs32)j`jWIse95Fk$;{#m}}WH)+6$hWY7b> zod2Ykt_^hJK1MIQSL@~H5i)PQclK1XLQ&J^w3aDfiJMa6L11PSb-hHv^}qaDMK}{r5Ne*S=S{-`6SJ zM{!>4M<3rJ^4=#D3U~Kci86xOUy-TwD^SOa#rg#KOaJ}-tTFc9!!;saiRG3~X#bJt zw5Rm7@1e%>ne-6psK(w<&WmBxvX#NGE|q}6TrG{pp_0ujM~-n1*RdH-S=S#(zOtN!d&>(6BJ7`ArPRqddNUeA^wMTT zoXp9l-k;zEFO@U$HO^djTu`r$3xbCS;rkag5U0kc5o#!JlGVG<9*XgLyd$gEyx_b=RUw4TbEXAcYa zs;85rRdcOWs}nEt=}~>IjZUm9>t%Y0GdTsGMd{DDyNn94AC*M7ozdl#8s2<{;u(SwdZdB-waUCr7*JWJWTxvbgV{~Tg+SlzNhU~gK_i^Q-B6~1p$C=&&BE#=ebd|6%36W7jjKWZ={g&f@aL-i#4eWC1SpVEaU)P%`5jlG+R z4VP+)wj#Ne8XlNAf_&c;BeTpiac@my$sbTC*-Jd((J2&1uNv_xIunOnEk!vdR}SA| z&T=%lAy(y|xM!iJG?KgYgKO8vgE|+pgT5uhZasO)j3%=C89Amue4Q5|ykABPe9C!# zNdt*^kt?mAc;N20K}~x8C@dCH=VPRSPycYov3r>k-y{pU7VeXY0WLA0(}pSA3Xk-A(KMBZ1lTK zoV08t8C&yYGT5_ypZwz!a&4W+CziI6iTXkr?&gVU)E8SGVt(;K`dwNz5l2P7Os~b9 zo6gMV-J6WM{?ys()fZFc5*g9c3jsqk+}|@__)jJtr#6j18rrhp-`T8 z_aK)=|Il&CxIUSDZWk-DD9M+RuHG;n2}Mv|GTy~x!mfWqu~rnx)5-LyzC_=^AaarE znONm$Ew0S@U2&GV&*~7YxNJm)Qkh5|*+ed8=gN`*4{V(miu)->G~spla;lN^|6rE7 z-8|9#dFup@iUha{uL z&P@EXuP;3+;Vfi)ImCR}S+ip{KC z2|LC8nsX@1@_E}eB$GUHBgy`oFZ=G%W5bu+Ss-~>Kl=LR@_xN2k#09VaBxp3vgjQV z_LVvHVa+9^VS(hY@PJ3bE<|mhk45cl3?T2h;X<*b9cJElNeJS}jdnSdiTH3U89b*% zoU3{uO&?0n1S8t!0zouFRre;j_7(^!}nB>kRha z2WKME&`dmn@}(F3D{V745Bx}mMQQFsG8@XG^2HLN^+dK;D00YO2OZ9WYr4IxI-V=` z!#uHiJh^WVa+ejUi%ei%a~TCTPT@G^yyR9V8BLe-JU*$hI1SGuvqWAvJ_L`xFhBZ4 z7XE3P$+yP^^2M9^-8|nw#!pX^jnL(=ehh)70Y=WMjIvz7~DmP4T) z^y&>o2PgU%_F%p_`O~^S`4YIo8(*n2S!t6oE}uTCYAbmeSSX8Fv*`7S`RrSa$mH`p z?s+{)(fyN!-}!u&p&#hXWGME0!Ag3{p9wCMti|+43841y!-&edObqa{lWlwRBzpsW zZ(Yb~-b}{N1H6y@>dP;3h?~g6hE3OC0JZ?vx61r4ppJw`X^2_qs6l*3CMFm|3)kE*-nR{i^&<8OYrk-luXk&;K7Oj zY_Qa#l0z!0EH}(l;9|M`6%h#WH%8Vdu z`YMtuOy2L0aii(+q)KJp0&}A6<7Ij)`tkJ)!uk>|-px$K{4r)YHjNUWUG}(KKy5!< zi?Qv~U@Xf_ijOg}`LPqGl8gLUiTkN_WFqJn`EFpW)STb|=g~p1tE)r$B63eZ_+0&n zl7TC^udWb?!VE3S@cuqIT!J1KBjxTh2ka}MALVd*QTabcIRAYMpNA|D2i$rbh)7!< z&Ke)1RSkNrCr62nyvyb2K>Qq}#gEy%UwZmT?ur%rN%V6J2*iOR9sH`$H{b*_PgX}u z*G`V`?a98V8(MVxLl3Gi#mG8HUTn4sZM*|aql;BZrtfF9v1)zk>rP_wa5g^3!>h>Owk`?>@2pRdFfe;qVC=$$a!jH2>!QYFy=7JUEtb+mZH zdEkl*`M8k7Vi#)JH>!{2u+^Rkm1pzFL6dpJK7zb1dj zUZ&7Su@X_ykzP#xs1mBhyc%ir<|{!A$DK`m2V7MJB4kTEbEF@`VF35%^`j+h1G!f| z52d#-U+dpvga**>uTzwiucgGM#Q`vr1zNTu74P&VaC{XbQ${KO$7P!u@V@isMn5P) zogL8o-_Cu?RI zhsgaMO+`{Ka(v6_2fES$Hx7^+C4c>VdMd7R{&~Q8?;<(hDdz$Z#P{>mgY!=p&Y$t| zGN!Zx5~$mLir_pf zBar)S+x&i}*A7;-;G&a`vDLe~8{alCAP`54WroAGmLgezw)tqVeRDfyTNGER6>(?A)+) zzH#BpOoP?>{e~y+UKv_#3pdQ@P~CX?RiR=0y_s%%FPt^3?z7v_u=ILElrq(@P+8YF z?ZQh#$4(F3%4!E0X1||kaCukXP+`8mnQY zv429{e?g-Bnwmi7F<#!LM9b);SSccZx@1v;G;fk1DZjNMvtlG=Mx0z$#7a`*M0rCl zIVgwU&ph~=PKi>jX@b16O%U~)7%6zhKGT%{(qnp_4zsJU*RwKvb=iO6 z(~G&)S~87%{hf=c`(M|iALnZ;TlTBY)-&&oo;>^+n_qH`c&o$pEqV;N&Uv*v{T33q z2JfW?|D8TKJ((+?%g@{=gvX`9ZE_k~PG>D+Ed3KVrD0KddN59=H$x_QMru~0BIu1U zJPmKigNMwZSL1SKdf3y$$A*2LbE)TVN=MzCH0DM9U%#h)Rr)mArsE%9|4K16LH_$6 zMLG_TCP%rEYi33Z=~B~48t%50$e&8-v)Wz;oN$maOPk2Ee$>|=+RMDx?D^8#O2S%8 z@xIzfuI+6uWo;cr$IR)juC~(6h2HB`o#fs@N4Zq2lBoU;GJ0q;i96F&A`dtV@>@$8 z>eG8WIg2lO$dPVNvgehvj7d<5-pW=At~Qgtds~p(c9e}gGcI1nyq;kS3<)wz9o81t z@_fIoQGqmBqQJKS3hbaq-11!|5uiMB*`jyDIOtX}pW0s&23vyD-!e#Ar<2>rUBQ4O7{c&ZU7RdP*W|mX7s?W4aHlH?v+#pB}|u)=m2Q!CcV? z2U#mr<$%LGp zCe(~FVb_Kf+*nFJt2S%o7pb3rW;e?RX70A3S3o8DC@eAIc@}%y_R$yePBPk`Nyfxg zWFWvy>r%;3dt{^Wa@K3C$r(0d?WO@4#Ch3xUybZyy=)A9nF*gYS@_0U@}Nfah)d4G zQtK?NTa%4jN2tS*2bhw^oRf<@+r?$U!bDHGB6>TnV>Uw!`yZcVBj;2$PTbAHwSTNL z3}@|y`bb?zY9z18QLZFkFpK@A#%zQcvv6s#i`dt1Ek*2WY&P6l23fm`S0872vByRt z;3Vb#Im)AZ&eH9wjcCpG66bC$x9hX#?X{hBo~DwFL@Q~$(?PC(v69h~9OUqUrji%S z9$|jI;AJCKzS@d&I|m7@$Sn8)PU7cjBQsY!%CZb+nYpWlOcq;dJJ6BY@2zFzNC!zx zRv@_#^Eemqxvy%LGh`X&tT&7E3>oh ziFCSemZFO6>n=m@5VFIjv+Uiar(=ZxdYm>e%c{c)xb?O`Qd^E)`kz+p%*=`udOL2j zK-i9A2~m`YKiT5QJ4LeM6mzVt=nHkq8^f%8Fw4~!`#zErZsdn3GQAZez1W{k7V#&2 zO8+sp!=D)uXS{G_o;RX4F*7vQ8+qk@v6k5&J2`Iht-N3{+!w~TJ}7uke~j;Bj|ckx zFIRK}d5A~Z^g8Y3iytR^(6WXvChCUavz9;Wi#Mv!AM3#sdPG|D`S)htM}7z@kX0BO zsv*;_LA%l#to}`J#qF&5Xqa0vUxQk#A!c(-)h2V2u#sB9P3A2WG0)v93@QA(iFzK~ z`SkMKxd{h8 zA!Dx7*RcsXWpc~CZZrS=F?~rFFmrkfGlkO0BfjNxzbFf;<5}=nn?)}I=CzTrS-}4{ z!7m%n&Ez+xQ5Pk*v7>1=mUST8vN01a$}y8=5c@T^F+@?hX0?hJ+xvrW=S>z9I_EzgMF_NdoH>KKQQEazPh;b*J!u&2a62- z@~65P!@Ugk^)Cz+R{Xq})ndLOD(8#A9R9)3;$X3%chx0^)qYit+dZlqFYk0PJgeBi z*x^APV~ti#jJk504Rt?FbF01bm7(*QRfecKC)`dQdvh`WO9f-VHEq|pj8|P;u9q@y zG$tBeUYvDdfw!O0GcVg<@Y8ka+1Ak*zbIZ>M$@ZgrCzk^IJxstCl~W{(zhg5u6~FY zTeo=md_Pf2*P>oBE?SdK`VkbP}>Q zUd*nsGWBqRe2&zK<*zsisH~OgmU@oO1gXHE`Q~YytS^-)EvD-v%!e$>GQCv0?S!&% zDzvZfgcUB_1Flj+^TP@AdpKeLK%Vn!IHS`p_AUKX!Pngp)BZSO;ZG+Vw@~6f`(k#R z=&N{?eS_p1Z8qOB`kI;p*X3+9R)qR+9;Xp&J4*9N^GSMN>6ex zA!H#RQeWD(hCNW%RG7?ur%m?*fU)dJc^Zh#P1X3jMvWiq$R9?NXB-s>yW}90@Lb<` zK@fKP1mPijrvm7wcz=HoPB#z6kQIRl@K)ocAA4l|>E*beIn!xsEPTQ}AZtl}w}arl zf&0)(^nsi}-$w2OYw`P=omQi9I{$ot*#u6(%*j@x?jL3XG}ggap~Jw%%uKth!=GJx zROzULu{1ptgV?Wfn_gaddYt6GuM+ohvE>rrKatr9(-Uy=IXzppvECX=*3n)Ei>f-r zvj+P651E|>^t$rau~$})rmKlSzEcz7^^chMC;+@q8Iv#2(OI-0Sgc{zTE&`yTsV0@D$5mA%eY z((!F~8Wf|_@nb?dOh1{!>7R!7Bj|&sWR_~Jboz#+;Ylm9D4}V%>(30@dg=5EOvi({ zjh6&AA}fu@N1|KcH9YrihB}W%`oW3YH%j>zpP;TYiuR2 zN6p;*LJFe(k^O2!|D;Rg4ZO0ELjEIjRSwRK%ptRujls^$yWi>{C!?L^`JDE$RI3u# zAUo;W(LpL*x4@KO3v`##_;K1S^~lGa%~D{%K5smpGz`TNzKD1^98vxJ;Jt4c0=I`D zU|<-ImJ7$`N?};ga5vuf48yuMmr#xK;;&}RS=^a|XJ!*FOiRHiYWMqv9!{Lc>N)4& z=BjKIS~3fg-pb)FEu>jRl{9x&iR`nHJZn3#9;d)zUklEq7WgvO0^b%{;PoyA#!vHu ze+@rm@)}*A;0yH_W_J4d!l_g^a{n@KnrlTG*ADL*^!Du)hO_hN`=w36&}SwL;oSZC zp9%Zla&N`?HIY8l)i@{5xX4^(UYk_1Gp&y(#X`kwaA_rF|F)4gpY3JvB<{nPmcqUz z7U)M`soL8V2s>U1o1_#ra4o#&<%eUVe9_0&7c06C$Ekv0=w}^<6I|=AZwW<%8Qc$k z=YF$WINoeZW-lvw!7I$`Oy-)B$^D)?*O(F67!kug()VnPw_r{tuh0A+S-9QPNpM*u z?t|OQ+}`bE-evluopzA3mAO|>D}|4z6*zi}jEcVn+P5f$JA?hOq^B>+9`wUqCm)RE z^(vlCzevk4m@kFFMXkZ#KI{WHz~`x37GD21*d`$Jxz@%U3uQkC3|5RjGljk@TzM9WT+l_ zdlInHI{|Sv^loaYNA(&R2pW@)vpfryzMX+%7XT zd9d%zD;6HKG$R)E62)m~mJdKLuERJhL^qLm?fogA#4 zBr|Iz%Fs4?>Cr7o%QtD` z_0NIVMY%VKp55d=gM)FmZ!mol^tdr50hxDnSf8Xv3kP~MX7l}Vy|K&XeM(BlhkhB@ zc_$tE3uzd!i5^nyGk;pm!abfG$TlZ>OZhQxb$Ohuphxu8GDifhnfKbCxg|a5dGXc} zvCd>+-BqZ>eZ-<5B?jg(+k-q)qvd3qCQ%cbNrvYdwVnVqnm*R!3ZI_?)M7sEO<=vB zpUWqp_v3Vwznz9hYtk`@Y)abT40=^iQ(2*KFVj)sZoaB;k6o{D|FlivK6{wL{p(#j zxsujZ-u8DEOO;C2am=@#Ku@c-oNv07!lii%IEAx^vYP_GI0rT1oU?4PFRX8KPFDF~ zZ?P{tcs|&9m2(X_v}2KB*q+S(qzv-!l{oe}7lv=(xpjOB{@qN$LhixWk!{?Nor4bj za}de7aLI%m?CQnL`}Oo^yxU4NQEkL}gi1DDXeDib*hq`|c2eyIdoP)z>`Xo4)Xx$b zQjgwxBP>vZeu%B#`yr6$o9NA)dmd0ELJjf3x7Y$=35YIlV zG(N!`V=^+*=yC;gc-i&J{&tPxB zK=v^`au$F8mQvg|g;9q6g+7=})3sg3+#X5SMHX3f;##9s}yM(PhuE}_M*WcKdx++#=1 zvY6gw`Rv28&!+ziy>mO{U{P@vy3C~K@kRdZmP#3yZ6l2zI!f^`2YHlaBj(lY>C3TT zCb$CmwTnc(nEt*s6gcbVgHWRrWf>uFg)(AL6V-?*OS8V zaUOdXmR>^7N7ON{reFcjT#4QId2I?>x@O}5ed(+4I?bHI_mz>2{*h$iM>|Qx!dCKR zZd*zF=pw%~%yDhhMn2Uf`!HSs*TWXbyjdu2nqrxnTP)2EdLtmt8;g(m;C*XfBsBlRsLQp;7Tk+_gr?J6~DgwyYDwI2K0(O)k*fi)%eopVpVs~`b64jJsBNQdRn z4Cv}`FWWF3b-0ENrib0!LS{M}6z*L%D%_P_I9F%TUvG7ySY1z&{A-Ca*)u`X$0SPH z?gVMp*cma0S|IWwna1kQm`4`=`zU7|ObtdZd+5D}uwTAYFb?L>cZO@)+DFXpxv9s5 zBg`!JOu$o(4lO+rQ12Q2b9d3xwSCY_6kva@1zdg|k^3e?;E9 z4zJCN6-i>Tk7v0KiPG;;yiA_27njE>tW>u^`*!rLOyhcSPzB32&bW7ny#ZaxQ(h)B zIGgjdhG(2n!T2{n0VmY-tIXG<^;`OX>|>2^a00Y9GvMh*u5ubVJu9wZTj|5TJRSQ> zS-78>q;S7S*7Kr~^P!8v{U&<_-X7x`Iv_!2oJo|o)sM>7)=6@uRFdr0w7^jAH`=ie zt$R&pOg`<5X;YnX!G?@^C_V9~1Y!L2Ahi3c#?IcWaQQp6@Qw5X`9zI;z8?P`>dom?^;cl^xd5H98JjA`n{4ommRo2X#c4c4R-=h-D zT8M^BV`Q%+DGJd_k9lNYuQ;QLyEERg#&FlN1zZ<6qr#tHRH>lGi=}F$R$PV8Jo~8^ zsgdWZ$C_N8t?KEK@k57f7d^^dps$CLEG7Mp!wu=k_?U{e)Ydb$^Xx=+FoxH|F_r8= zw8H&5uTf+adlx#=S1C^`%O)ps-x??919bAxK`#-%oZvfLg+{HE%!i~mbX6t1YCGcj z3HD8_{XeEreMgP4$9R@aq7QR4+0M`OE%8af%&$5OAD4hrWKmOZvVPc(e$YIRb-tDc zk80`kGRQ!bkiqA=KA(FHyRE!m?By8E=lZ`|*nb~ZeJrI~26><7-nd{Ff+_3+3v8c> z=}jzUO!Yz;7~z3z74@p>Hs*Ad9w4%EE-|jm7;o{mZPqFnn7G*+k|M7iYrbc~dDfDvv#veQP2NzmEE#zgndn%9+?+?gwA(Zk-5o>m^OX?|YGz@1t0uDC?w_RV zJyGgW2nO8?D)!LND3&htSUBj)_em{&OaXb-v5h6QMxiug-t?Ctp;*PU__JG? z`2CxCvSa^9nf0FNbutv{b4Ik{>tq`(<#6`@L)uyYMU{tdf52Wl0L37b2C)wV^WSEZxC!&XA?6pPCsa#h9%bmejD*)b?Y zmGfB4-EL?jy~tx0lYbl^z-L>p|K+xQ$?@}?`HxD1enoE~@MdJL>8-vOtaJCkm z-RAV@Ju{P}Li+5;b>1PDTH?ffbCW#SG`5gnb%m@O;fqeTkvQOzifugaR=nQBc9zR( ze$FRci@~5j>a;D_Ws|ZZt=W0;(YMd(Lj$TAGTK zk$IeZ<8`#AMC!NohN20*t0!2?-AF!^xyCE67l~;dZ=B%qpZ#2q^DB7XueB06S1h;O zeDIHD1a=hYQC6EC$!E>PwN|kh{_@7BIgv=|!TyXB`yFkY${Ky4n0*|9O!AC_caUR^ zVz$*AE2;cY$UTz}verbxlN@eoQZCNFZ!Vn!nLoaQIq4h8L6e(KBd44iZYM<-d4Avc z;7J>vmqI-nT+c(}pcYbiw@6(69)b2FcwH}GoqJaqo>&`8%@qSCkGc_ILnqIqf~m1 zz~e^|aI++rx*!)XXW2-8e5tfg^+nAc5ilqBU7+H5zu#Pj4JnnYj_gs;dmEdrN7ORr zYj<&!4UVPqrjs9P42gglKhKww^HBR{3+YIHS=rqew%m`-8kmZjW}N$P$a39`MqOIudl*(0>${VjJMuhXyW+de1}r)YXe^Z5SHrK0a5e*IxfF+W{M)|9=? zsq}9)O@)fTZ{y`w@*<>A0>As>6VFSFEczl(=c4#@3u!Z;SZca4PwQqR0(|v&T$#%( zf)-?ROJyB7_sPp6u_9NG^e0QtE8IIKbRow+(=_n0uuxu?Q_8yRS|tP)>tACsRQ9Pv*lC4%a3uc2Yi?-lyI z=F<~rN-yE}5JaCO2ULarwZqI6J(MUn%Iu(66M_qaROqycxycokQ2EnGO|DQ@grX0* zr{1H|$x<3IJt$F%=ueE@77XKa@=CQcFk_q%u7Ss7<7r1sn;nb=?BV-Za$fFLC1*U2 zai+l@ny;bg#M$KT!m9w!S=*yEiK`Ox=C|C80&eiglhOJl@muRSyD$Vp97<4XNZM0cc@ZD+jP z{KElf-h|K-slpiYM~**?81ng;RM|p)?Rp4vy_2wF0{2rkWSb7zI%*?SebhG)RDGmk^N1X0t=8Ff7r&wW+& z#xvJ@hY^?dF^~JcJyOqwz;!7508i85TS;GJK#Z)+vZwzi4A$fvt=DFtdqE|}9pmS! zwF4}xv-h!Ag@h@Y*m0r~Pv$2`8FRYbSBGNV8x<@|>IOQZj;4zHu4qrn(^R)zMB zS;HGap0P)qTzKV(r1A8nJ|QnQAph@Q2|IfVO8uSU)ij`Mx zPB>p94FB9vXwZ?8vjjaF(ffFh95CLuWrB4{OI~y;bp&+m`;p2mJihRbh7x_HFta(eQelyn5n* z`wf_99gu{un9$d-P0YuKKx9 zY&B6KQOmse6rRVTcv;KqD5rA>^4yt=^N80)ZzGP^j+Zv;c;841Mb)m%gXxfo@82si zm7HvgP03% zOOBGSzrp*!$T4x!q`m`|MTB8%eSS_>&>KfSbPb&^KRP&}l>GP}UUyr!Wgs)qh}dUb zkFGgjB;BNm z%P%i_v%z!I?vJ`>W~Ta?lmFDG{Ozf0y8o%JaakR`*I$3@77cOGcRL%S8$a=E&lz7$ z^p8z0>7FhcsXuIALuc4M-g9XCs+Svf+n_tUYNKb9^Hw@z$1r_O(~h1dmpgfsulrL! zc6?*qf!qJ;F4qXZw6oLs%NOX)Ng>aedrT!Q7bS`LnB$UjH&M=9P>Cn`#-|$+<=jGz z^#4Lnsds`5nVuvIKXcZwaguDEA1^yEBuT8FS~g5%zncAmPl`mT@;83X(MmJ*3Wgc^!>|D_xk`BlkuK4xX2{s8%XwZb26wxkt z|J)f(In#ONRw#5)p;+3Dvy!Y&`)p;sYHKKJ^I6}9vk~Wik#}W(dd5U0x}0I%dVd&x zc#^q($+~(iGP_rlu=~gyB-TxC_f+CavoPdU56Ag6^!3c;-#M$qJ!d6$&*63cXE^h0 z!%*SQ&+ayQcnqwOC9x*X+SG1aCGtF#SjWB5yV@GG`=Eg(dnvVT=&s0MFWQRUoG0Y( zn`p3{z2@aV$s7-7_R}>D8n6a&H%N+$F*HeyPu1w-xvR!e{+)@Z==7PX z#{2eGF`96nn)EE*3+P(fcK2^YW#VEnSNvyhq4yd zK81PEoYyFt%X-G)EL`8mJ=xG~__fbOI&1Vhsxc#jeP^>Tnds1sb)hGjSjw7E%y>F? zqOxFb#x;ZWtK(joSkQy>x&O^BD>Lz%b(;G}nGLm{f4@8X)04<>U&zF8YwmTdvM}Lg z79Nbu1UhCizs+8(`?r+@ahBL{H<@kYCVQ$nN$+NMGP8=al$zPd1kODEeZgKnY-lCj zXWB_M9~W^Cw33^@?8JV!gPgnNESriPl)^hT!y}W+h zMgr-q@n&t>pR?_+EZJ-IvynBm-NfCtwQPLMezduR*mSIv+EdEJzqe5itmm9!8+sK} zDp>oklp|M+@<)H8Onaq3@C>8$t5Yt=nk%3@Mo<69GFjNUTt2K)V12hTnK-smt~r~a zPhE0X4(yXosg$oV%)`A_A^yKB<&Vt@9R5aMjyHXEEltR?Gpl-jr9^kDklqoMa^;Z% zveE?ct9wnVo<`j*JR&+12 z$Lr7f(U7rG_{LiG@HNc1UBo(86#a59BVn~M8q==RyV#kIxj<%5vlr4bggxr_l;&XF&w^^WT^8Ym3%LqtW1K)EYp~KnDY&M;UNql>tij zlxuAjmT!8riYW@+%FiJPc_1*?^>Z23Q&la34p% zPAOT)v{YmsGoafKIssx+(fvE?9_gu=-H*@BW@)%PleyDB^%y~}OXru0kF4iu>!hLJ zUjy!%{?}LMGvZz{h#}+*?Ab4F#Qw+@G6=VriNL!1fVK1+^vuWR^LfZC&d0tf1-Q$) z)4J~Y@Z@Wsr7=7A95bFe<-u!k9_CsXVAYF!W}4-pK$!>YbM(r^=Am5^_N4dZNX0B_rGvD1MqgtIT}aHJ+^-|s z!8%=mC9j*}3b{XxdG0&PW!7Z{{VPU!Raq{3(-rU`2Rwdqh0KkslwBW`MsFz$eVIWy~>^!b2Xc>-{hNJDSh8pNZUmU zY>72Wyd&MK%$s)2QQ%2u_7L~_BJ!gjEK->fwurgy2LjN`o}YVizjetOzVP;k(aayk zCH|=M!51s`^Sau@8sJNRbgCM_enbEokvYEgmp?A{VK#hi=CZw`i;MMvBW3=q53sM4 zO!sMje|+UL`svH`VD0zEb9ZKd75d`PUqJ{<wPPjo7 zdW_*U$$nApE4sgU-94#FXX>OVWb(C-0-~^z|KIXm6e6y2W;~Jp(@o@#hesnq8I7I% zJIiX)?{tIL*hkKnvbNSL+kmr5vcJyE_~iApwiB6+5xjOP=w2B^H`Q5wt(O7cs;A-X z83W2E8-THCm_Cy}l-107<8`JV!fUk=ugz2B78|D`_*p6@pG<` zk*fh-ymng@@%67$(QCAUGYssh{m4h%SNV7_K94Lj{UsmxxhInty_P;xW};b>&zRSo znP_eDq4~@l>YJ<|Ud=-lUW57vtflk+nN8&EI{!{A@;P_PY_}ltLB0hT8kC2P3-YjP zTRxgrqsQ?}9$t^+b#ycz)_Q&|f!E+Z{=9$qx~t5cc3-SxJc<7Lwk*#%+iPF8od3c@ zce=LjVZ=S1`?_%b%IZ2@%iT8mULN&58(iwCAJF`&?$E3+x>kOhbTw6tJ%)c;r}J=` z?%|WYMVJ3-y@&U}Q@Vf+or%Gm*sl=zNTFgdsrm(6;wsL=1 zSeHKT?P|^tsn~Cemn+U1u_#cBJ?jtqdyq#os^oXJO2*w#$s%wzW_q&h&EnrrPLgcX zBq`s-IZbt%jN|vUaz(qw&RG4>1u@(QHmO5r1=$IZcZqxF zjDxpb5WziSQ13A8cUPiLeeUzDnJYPo`?tDbuwY-)ezX$N+_x?76ppNY;bd{>C26L_ zm~r%4^-yB*3py4jDly1`E{>*3)E*Ry7sA<>+05o(eW1sm{643YSoWt9uGwLTJ;HqI zc62pb)5GW(0$(-vl?}t;)HNKRxyL-di_e66)wq+O#)NRrp^)8}^o@**AH65nG}ymc zO-C&KFzk)l|59VmKn?Qz>Cv*_Ow0fc6!q!t{+BbZ%jxarY@^3vdb)j?ZPr;0ud`}Y zyQ#+MwQ4kZ&Hn5;HS71x(L2l8nNU7wr7_$34(llFw^hmEeA!ZF4Ll`3xtzImAhCHcwekb0?dq&%*auX3Lq;#p03$PwwL;Mlh$9Tw`n;=Tx{qywNZl zPf{{a@R~D{37K%__f)gj>Qj^19Mzdy(3ZXw`z$Q+qTgz7CN5v+JdBR}OFOzDyU_pW zPcE`L_mk8AAJ5o+qrIe`bd>qmT&4YUH+j*qv&{WsD?XtLZ2VOwBk5%zFW7+h zvyp?-&>_lzSn_DAcJbOT&cm+^GS3xcpXp5Uos|#gGAH)Mm@#ecDE^z;OK+o{EcoCi zH_n-08Xa4+>d?7eZUV(}u0>=+{)rC2mvleoBKTnf_gD35=362D7s5>FQH+I|I+o0;OoBf7vQn6M5;hGs(mu3HCU$}M`X zS_NX*s6b439Ec&V(O7wlp1-NlSkRq(%7bY9nol2?!hp*8Y52U>z~_!M#H_f&%ohVD zk^^6y!h3I4KCX}pDR!rWT0`bw5FLn<++{{}XNllmd(=-CX?vZl$}Cefse$?2hky-_s1`9W_L~s!s!ixaOoJ0rQ^xV*wPsZI;F^;wy4ehpD&ry zyQ%ow$o<|s0|M5j0i|T%6Z0@?Q2}~~=VKy|OX+jYe9S4p$K9^d+p)8l)b1kJZRub;@@QfBqGEiwoETJYayPAM>v(^YL$Ot~sp=;IN3F8}9L{ z#TKBSlcU@yv6r=KcX6uWC@YxV`S5dVxmvYC?#?j5ja~}eBX`;$M!|kBIi5#>_~T9> z_xyo4d(|Jq?*&5DIRMTEI-89=R~mkvdG0K@ANZLPg(&h(>p34V>Jn#sxPGQd8oX+y zA!!$ToCi5qqsm8ouL9QF=^P%Gk2$^?*)=UuwiapRSB+%m25P1EC$)_F(+L)3yhpEf zhQnTGT%PI%Gh1i;T*`dl6U>~BQKH7PaGbFT$3ay%Iw$iPGlp|>e`>KImu%W&Ey9yE zaHbDvAMXnX)Y<5MGYb=W?RPm%PtjcZnp!hggu`8{3ghfD-HdIN5RcV(HYOY& zj+4)8#reQlTKW+=4|tFF$ZRr&ZhXEymdW`Kx@ccyqV!27T*!pnT+3PejpXylUu+nu z@Y-5TXAT=6BC zp1*}kbi1L%0@e#k28HALrZD_GMFym;77e4-7(GqP=W{JO{$!mylsS~E=x;hfSENlg zG6wT`+%p^7SqrP0tngBhPg&lV$Evo8S7Z9EUYn)JqRU#j@1>Q9M_LK{%J+6%E9$YX zTx00ZoX2yO#dYx}^Dw5l;8Z>G^UvrYd(D0U*Qkqt+U%57pxGGYuw~ zk!k0e;Lr2ZfK27EZCQBOp6uz$EEH~JF6C&2S4u4tuVcf>snF3__dlMeMB$Z7o=ACI zExjI`kP)vrXM0s8ZpmuSCOX5*%mr0LoR~f5g4-uuF=>k%o|uK>;{0$-a%4v4StaKd z!qJWAFl{dVW2|FL)M;_^Bx@$y=`NV9LFomqA4ADA4#~pprCFG_m34=!L#J@WriH_cOwpH5O8hZOgCnfl{G9Y(rUqH3Dq2KZYjKM2r5}I( zU_&O-xVAYqc!F`CnMc7|@aTQ?DYRF3WxS^2ig~Nw$>+wowUsKToMm@ECrOER7d83D zj>FvKBA@$jIV$jJt0@w*6j0_@h@RKG>1n({ z$N1mQQdr?ATO!+teP(+(_sUJGF1M4BT0Uo;Rv^Q)QqoTu#ksZ#-bV6%nB<2xy8{r| zkB)k-9ecBaSl=Swt%!#Ckv-UG8-+a|qmbhqjRM}IOAe$lyUc*)T(@R(O%1_C)$)kOh5+u~B@^V21MYX!u!1BaH8- zpPtX?e2#Hgn1-lzY4B;3hQoYr*SF%@If`pKp9um67I4m($EbDz+PJvM!L=Qv@x(6j zkTs=wTiZ$1;7(%Nw+aUH-YioT=roe7-t9_e1~7+%nb#wF_`~UtKSurZhxP~ExdG(y z1EcXt$iLr-Mzohz{p(pYh zpUoC?jla(|>=jwl+xeIrLJwkcJ}&aSSs&paIz0!a+R4J!t}-{*S$49{uwh7BF>g~T zZf_MBzok;@%~hanCEZ%q3K(Vv;kkI9X2|(k9-oYL{%FAC^Ym3TT6Notb9z40 z^4WA=y*(Jo&&~)xuBEnDkij)x_VK-4=5cz@{E9H{fqHXRVJhn*;8xpqAc$LSMF z94%4eyC0n^$?gMZC$xw*_1$jwrk$ zPIKM3tnf-F2S0-SQ;T<6*+CD0C7l9ScN~{hj%qo^bv4k9{9?KjI((#KzJ)WA;D%*^ zbka9gqTx68vb1#gb_iz(57>(v zQr#8Oo37eMZU}wpg316_ES~Lxk#0&<`Kg4C4E#$`;sBp#>J1_PIaq@c^|i1ati>fq zEo|m%aMel+`@&2ljLJg)nVesD&c>BFS?D;2nTllJ`*2;K#`|&!|8)DQ@cI%(ZtwL8 z88lxbSLP?l!G0R)`-|-0g5y%-kqb`tbisri$1xTkap`{yan}=gsZRR6gq6cV{ z5?x;^(JV;G+$Sy6ff_Wur^WOY^j2nQn6<3IR5GW3&d)}cR~E8(zOn~rY+nyDUt+F0E2{b>OkF-@*4qmvGLWWXZjfB8AOVVo_Tyo4%=KHu=gc>@`>paK?<| z>|+GD;7ngS8<&M+*bF85MJnMvMhVkGo-58#jOR0y=`uc-jpt{kj~0_ZY7n$TgD-tJ z+x3a_8)LKJ-ktMax3iF=eCCXvuPe5$b7j4WtSEfrqg zWIszL{6C&Cu9~@AaxY{ytv8O5qtQArM|esOes*XfHe1W3)oF5n(Gh6-UXPtS^YFN= znOwV7CTD+>6SRrIvxcnWtjWc<6;0$*onMknkKyTo5ePhHfUPkHCDG00!8-cptbDNd z-$?8lPkyj%F1}Z@kOpSuQue?bQ@%#RxK58y`#g-TXek?qmoPKN2PNdQ-rA;O$E95S z`r1U6{VbGyEq(D%Xe2s%vsSw!2c31zWM+1uG-~6G{X-*hmmE_@MlO~)Tg!S4IkK1$ zI7=RC#Y8<+fw`D`wUyKvQ!bB|(BG#cxAl(PqC4}QlbK`Nyi^V^_eRTL&IN1qc%DX{ zu{vMhsZ>5rU`}gsB&I3#_;xJ^mzLF+EL(D*;ePOOVf}7!Dn^q}Y&FtSCh7`hS_X4( zH%FpMZF(D(xft2fTHwq~8F~rl#{I{Q>M)mF&)rrn<>|p9NpI(k=G`LkXhbSTUe3c{ zG?zJD%O%&8HA}}xY$GSNx+i^bUt3Dbl|q@a(HoT`BB8Fwkm|RJ#d4V++763AyQ6v>eUgjd zzgx=eH9Wsdy|Ia&yRrN}BmJ0@a?x6Dk1v;-VLmt*$h?`QshE|X%k07yl6SaRcD?t; zOCFzBXUJjw%EjfXEhTAAk<32hjXL8a=*H9|;6xq<3~D9cElT8RZ~EE>N8qvtIWLbq zyfS&&AncEoA)#diKqI;mY@OzJ4mc(^8c_hHVpgAeW;jX=xKI(*0{|24>3`qnL#U)dvYfgIm_a*+xf zdiQ?NXJ=g|)pyamH;kVv2m0pB^Dt*)BQfn=D#ZhRV8>eR97QU=ea%Hd3v-EO4)wQT zKFnT^gkdr{L~@angUw`!N1@d5_QnYEuulK#5z(CWO#5bX-J(=}_wd8>LlJm-R*$;9 zb8#`cjl7F5lA&rJyj&FtH*-DA2haZ?{i{<-A;U8qrE-buN{@ z^cybO9f|D8%%@Js#ryH*(maG-&Y3=_9YL>OV?BaisHMlR zD|vW>7P4+(sSM(EG&GkSXbS7V?{cy3TT|IRxKO5(4_!DS3ZpDiv5eR0&~r`Y=HwE2 z$n!O)7JEe>_&(R=V!01{46S&4+W3<9Ag@;~6`K$6_`5WfSu@JyO$T4xoW(rrL%eT{ z%0n&YMlJNH5X)#^JXsNmFLYMu+U6kac2n8Wgx9G#=OPv`vx}Tsa%m2x=eLkX@#QjU zg)f509lNzjMb~dR&~3Dms7-~kmUVZj6NxjK^c(ic<;=aMTx(Dw?U_G*o%gZcr*)ib z%EjJ&w(|9Jsl4mui|ax^CV63xlYIY&t>w+zLQ$ywV5k*|tLK?FT|1AnEmktrtw=ia ze3kP0{o0Fu(k8iNugsCLdXeXa9)0dG z$2`tLTHY>~HjS9=^ltw#SC`_e{yyy(qb>x1)+m>*5ohuS(1t=z5T{r5u2OY=c5+X!@IAFlmB zyq{0DmznQNr0dTS=#mmaZzzxF=N#;FNh;X?la3E@Mywm3BuzisV`=SB{K!Z`mOK57 zft5HSMKLa~DWwHN8|k0(#pB~f|}azvl(Q1)cV&GpDYGjf0RvX4pUoAeu| zGuN1Vii+yYOPov3n$0n}V{~Bt1@kC$@+9?BLZo6i-=4K3$*w!3Olu zmBfmd2R(h?!jQ<^-e>gR)weJrea2C#zR3ZzqC&9PUxndO8Ax15-c6Gr2ZlLda8d{+ z1(K(mlY#ulm6%r$FHZ+MU_bdd%RMTz9+81x2aT*-9h2%$>@jyAzrHXDA20CtB{y1Q z{!uaK`|%tZjEoN|T-0Y^)&TN-n_^`KIhBs~!CY%p*!4Iao;+XWjS}Sz^Q_Oik*{1r z&XMO=ai$WDa*oImCnvI%Ay~zH*b^1$sL{-byg%Y)W1JnfwF||Uiz;Y%9CndQD%=|{ zpZeRuXXPryk`ufhK+on=BgR+6ib-92^vGHThviA+`7&YF$O!8yv9iO~5skWqGIx<2 zCC~eg%awRtB~A*bIAL3Fdi``NELfC|_2f@W>6N=M#Q|ME2V;Is*8i-Q;e+HCR!3y-Dm&D?8w{U+lMr5#fy!Fs_?+UTXqp4UOGDr}M}?eZ z=4c$+gGM`@v{>R0Z2qa-GAB2)cPxmb7$0;!t`{3zLw^ulL~f z-qR~V%zd1&^L8ja>XG-Hnt_csj3~YnE9<`5BP=VJsx1{}@%vX9Ys9I^(e7WtT z1dkQ}G|~51u~ENwqLW^^Q19XGS*|`%Za2S7z$W=I_<@ zshXmjxpkJ_cKTXftF;p@*KG1z*WM<}qxJT$p1(J}(G7O2uD@j3TwfIRz;ol*1YJSh zIFE$Mmv#Bq?(0hbYM@`zVVrKubyI!#(;d2HtlMm&C(++5Sz^v6N&H`lGFFo$)?Kx7 z*)3VxhpOc>8O4|hDhZmWmN@1BJtvo_Kg3MH1Ie<5z3UUKGdoAAq&HoSk3y5hvs<#X z{>Yr_iyCP^FiG|*RWgGfNNp4TGlLGseOhUGCP{9Qlbp&vwT0htab)kh;U6k#w%7%m zIYXH?mptJY-k&S@-%jiwPj;dI+67OO=}z42gl3&x5y#gmf}GHM19PJJ|7QDt-UtO@<+yxyEaGl-4y1_tKykrmM+%9LluIY^2UH|33yC7-1Ggb~|or8ZO zzd54G6GvPa?Tkgm{22?B$f_HTD?RA_)rK)6J`5(DGcDT5+0KPwxHm5ho5`}bjt@gd z3VFuiVc2z1i8t&!w+!OkC+kUf9))1x>o6>D8wRySIGM{(*q*0@qOTIq*tfniISl7* zm2~{jDazNY>(JxKe!*nVP~2^z#AwbKL<-k&SJtSi)2qY#eGu15)5c^NS)+f~hjWsJ ztShLQ0TG~vcNVk%x@&R!DLucA8mw%@e)e!JPVm0tmPl@~4{IXBSR*N-ua*6WE!_9S zepVqOh1~i%?g=c_>`|!E<1+VQV>LMSo&4hxW=^-!pw)U6mX))g(~UV>?CTWG%E09Z z%#cpYgzqb^#q3us>z09;l8O93GBIl_x%~54_?W>y^+P(P56~OonuSqIvM`o47~?+n zrmJSbHaipV$R=9d;~c_i)@NADQlH`BiK4oAo@99^4 zve3^16

k(3eUSN@wI2>xvLzU?kG7;9mTIr zYq?f#Ex#T*$w1bd7p!)W?5_4=H`i6}ZnTwjD+l@2+fIgsImyk%E|PGY891vPWom6_ ziLr2!PN{Cv>ye$TUt%qJlkH^iTs!${XD?BG-6hYbjZApdTIOh(L;FgB^FGX(Hdi3! z2KhymQ5=?4$k%A*PCr#((gkvk&FO*jP~Z^1*6gn%`Da_H zv`kQ-`X2$PwVRAofgf(A1R#L?;-S`o_-j4;3JF07@9l>X*ZomtJKZ)t>5Y5thq++y zW0^my@|myKOlIP;@44fLKfDjnXAnXUV^g~0d;`$pOaRR0_+#^YKj>opG3=)==UDyd zu?xV!$^bkgU)8DDANx2H*u&Ew7PkY)Q?UOY6U~_$a!`l)9CeqTx7(aMbSF#oo6g2r z(YW<75>hL2!P-p4abZwwi&3O=VQ`E%7#INXFj2=Z7VqscPHvQN>2z5ieI zF`6*ns(}HnEtsvhlQWWTWT{T3!oDND3?0*O{v~VUX3WdoXTXfF?9G$Yn&Lt?!fyi} z_cmbAs8kHRlZrpa8(3#%jqOY-`n0Cwrg|!R_f5sZe*77Espz;km3w|>cNB2mEP#EH z>S=Ji#q4V5Ja{gkcX2#31lZ$mGMn7h`8?PSW>yn>ImhSbWBm^Pvl+9kN|=Gm{zVsC zG5}#kvQrkT=|!kX*Bqbs{j&0~lz->OOuoK6 z4+;EU_2=i|5r3ZQaX#wr%twtubSZ4L5xL6;t|9Us>79s~_(2>$|Hw`|K*mH#kc|RePC7Zt`bOH?iK`TF#UGP(F5%m{uk* zl$gLf-Y9FMjk5cy3A(x(WgdI@hWG3fRVDN5P%b`hM!9*sQp$(Z+sNLL?N$X&3{+sL ztpZ;cC=m37T;fn>eYIgLt*8IZT#9cdYY=b zF^|*U59O!)k+wSk6+c+RSnH1vZ(r71{jkR}0Eg=a;>lI!WmctM#fE;T*1l-(?}xr) z{P3iYKXl#wU_vh0PwR&U!~781pBZJWomj2*!@~A{n6@Q~_g?k}XORQuHKi!vtn%R~ zZ09vIc`SLvEM`i3@mhPzEQUX$@fUkzQ6r);V@?#ZO`|YD7X{aNW^iUpu}0Cm z4ttKHqM2L6evy_LI}M}Y#B0`Ih{C>^{5pB#F>RR_H-Og`|NYZ;`cipKj%DAgeo`t{ z_h3d)ce)u58PJUEp`|@%;NuNQ=|z_0oB>a!F-w|!A>%2(H~XC5 z@8%(b*X`@&%4^oqiaFFn>1;gTPCv2bV!dJALEYo39=cOUPU=jy z`{_rnX{X=WZ@1^!HeGdDmz(JtJ$k9TTd%+FpKF74mg?%gx}F;5x$x%H%RlQK*VXfN z*45m0Nq6_tj?1Zk9oMDYZ|(WVkq4gd!|PnCJ}N-Jpyg!VYUZ!f%>YR-v_kO zt?2(o_pH@1-Q%uW&vnkrb!m~`b@fX9^egf>ccMrZ&VF+;H2b6_YPIpwx$kA%) zaV}BT_^2hKmr8aHQ%n1oYPsc~EHn41B<-M9jOA+Ce>PbrY*I@DE43t%e?0WkmEL|g ztTND@IMf9WMrVv9^AR89f|Zk8@VW_epmQBjZ#Nm0pPWyt?S$dcE*Q(#y4+*$rjH9+ z9&w`c)EVx-oZ#M)JuVAp+-dHDT7Pq9MoEYFIVXI);|P5%@{UhA1GC))3w}70i*Q9Q zXSc>}q8Cc#ggP6YVeu^#MYqGy&?5|PbHnh7J*mx?$eH}5WR?gSj|Oz3EK$Opd$&W4 zln5dp^L#gX#dAu$>&5-z6*?H%+6#W~bmmu=@#pY0mfQI}x}UX?-Sn4n2Il=$x>i!?W@Ihq z*I_!mt?B4y|1JI+GZDD2d$);y7Bcs9ZWgARlO;*aLPhN?H2O0Wqwi&+@fmtzj2YNw zl8pot&cJYgcxMftj!41@}J>Vvas-C21eD*!jT&EJRacdDl$>yeFpw4}8hTO;&t!mILK3(q@dSy!x)dtNjWT_g0{?feETN zBL6_HQJc+q4f_D}>==l&#erx!!Jiq@fmrjNvlfVkSv7iVo%V3v~ZETv7M#G*$z@+ z;v^OmTqJG+9TR7`f8!by+s70`-)lR9?{^eat)uvO(h*4qSl}Bn zpK9hz_oOd!6#beOfr#i9h(Nw4&+BA(c#PV7B7;gEWvJO6)>@fsdMFCDmXO0JjKY)z z@;h_s{?gEk$bH@E_hfg%({MeHzQHdAXhJ6B)sH;1NGw2G9xMM#PO^EgqwF(;(*r*okMo138=Z*F1F(gR zOrzo`wBbJYU+ZY>qgV5yp7S@?*=J~xhMPOmFn^FhigS;3BogrAWY_Z-)e3&H21j=ZxapY7_RYE_rSe1`5m68np}@9RvNHl zPa59wYy0^5sUA%RRmru^jJe$0bN;)DzN>X=nNQy9K0Q)<+MSSlqmN7AbY}Fdbi{z^ zPBMsr4$rUW9N1xO!a*d@L z#I+%tc81S;1L^jkMz)|QvpUnr8EnahEi*~d$qrs36Bog`+EY6fUj6Tp2kU-Z%vPvn zS9{huIws2jzZ2p%VU+m3X{XiGyd!lJl9p`%We1 zMup=7S(K39bljSeO9|9q{&Di)?U{X`&cw+5%);qT&lc}r|G6U9l2IARfa@OA!TTZj?F~k*9PmsO8 z?@E6#>kIZuoaBAJZ^v+?yd*1Q8;-R}8qOVQab%MgwN}#MRFCYSg3RSh<`#_0=4-Q2 z$m7)MN*10Rr-P7eTsup;5RcO-Lc6v4<>eIK?Dhr$QGEt!=`+0@gs&Dw7D#%zi<1zA7cs(JH(W}2k ziv5zMR}yo=xo_yf*@%=UWHCCqpjrtXS8H8S)RJp|A2<9v!4=j%WGX#aH<>~&a_w-K zbymXRY&fcTYM{&FpCCGl`>T;}qD2>XEp#23t-6`#CpQyg1L^(xhyI4PSr{^g+0tZo zzH?SPZJ5H#_L~vH-1R0>wNcv&sb^c2(SFILrj}!7q%j!UuOD2t?fleoRr19ATmv} znK^qS6K8gj`5e#8a{9;4_ELEHI-7XCxTNsf??m2-@2B8FYw7aVMLg{~O5%+U(jv-P z?9RH0?NkMt&#I6X%}p?Dd=(T<zC0Fy?XfLNl+mAj19yaH^WRegFm*B4EKhRyE27chCfAA+(dZq;eC1yTB>ynLf#(;@G z)6n)l=k%-!puJD8Zy8;_e;05zgU`d`+~lL9vp7t2l$u_4%vN@giMO2P4Ee3*WcQ&su#ZpsKEW1AvdsKnYPYlAXM!YAMl5hMFh+Ew_1E$`C69v&2%=h)|RupFO zPorQ1)Z^1oxtf{N4r#E`8eqe(b*jU;z$0A4p6BDff!_5^1;}2@Jnkl(-<#qhS&1Fw zkDa#S5#%B|o3_#?P=Q3=qc1J3kX0`fDB{}DDnWr|#eT5#3BairoNwz90Q(SsY$y!i zTnV!YzeZzv5%0?vqv>{!MrV*WzhD42#kl_1KqpHYbbMx7nViNvwK59GD zWf`827_RfaKcudyQ=g)n{^S4o4yQAUoISsCstap6na~@|q z($mwB+LIaG4f(9JjvmBcoYVB6>+^LU#>D3%(%n@Y?8)ZFwv)@%U70`PE`7hah=S{A z=nMt?8=D}sohgQ~-eu8Pfh3(j;wA-RK4&OQ&iW(tSrE=1@W+_G-0zTQY*Z43y%YAJ z!Sra9HQR#=;|$2MO2ZJY>z#X~p({U2ZMn|RPRhg8-~!aH#d=7;d^9+bkINPGGaXgQ z;Y^jN`l-aUNwPGmsutr8y7s!W2HndUjV|$7!GsR?0WQeY(fzlAJpKyu5!G7DGCxOVX#bSRb?y-O5ctyj_q zOO`q?Sm9OUF|Yae3NPy`8oA@7l|d;dq~D0+lHzkhs*^c?_SOlt+?|<4PTxGeh;}({ zSRFu5{dgsmF`SjMQ=;`ku4R1gsO!LcbVn`XHquucph5i!8tmJsLHcqH;_op3<}m$w z(VPv~lLaP>U&&L+Z>nJ zCu&h$qZ@LJD`tIj;U162CzrgXtt58wRg|=TZ zGs`sy9>STZ4I12w&%}DJTUYqL3ZJm2Ixma$$80o>Pw>?9tN{5xPDMUc17ubeGJ)^=e53$8r=8LVzC8h)%fi5 z*ee?aVSHYy$imjytf?Q&#OnPDubLwiUYU(dyu!Q`UT4e|UTYUByoNa^NzJ+%Y0a6E z&h}dAk*pDic)C8}3X2`CcwNf{IvZC^h;>2EAy?cICE`Yfaqct>^ZSQmR=>z&c_h}eUK=z)`bL01BktxfB^{)){Yr!lg`i{?$cW@s|N6QMX z@d4y4IZyF_pTqv#)k>C}DUv^G_+WH)1bPh9V?q=;nnzZ09D$y;NR5 zC#U8biT=fUd<>-jvA=~Bg#DCj6}~W~FYLEI6$7s4;@V1UDS22VZhSw-yvXH!rJu_$ zA1y{(OZwUp3A*EraYyL6W8Es`S1wdb&87U!Pw7$Njls*9m%UYw*9y+L2ARpU?ZvXm zYy|#l9*I7KSleYS$j_0v$yZC|)*^4XHjTorJ9B!D@paZ~7d^iD;^ z&^&D3VJ;S{%Vg(eALPBDH*kL{V#8UR8q!GG`&LL@8z0o1$-4Pja%7X3Yuw&aPR}oq z1_Qj&fWOz?7JAGcNMGSS_9#{r%e8gP&rOQJ#?|DocpSo4w2-1*mC`iA2kkr4cUD)A z;@!E}J<3*eFH7X*zuu_%kn_*Kng8oWFJwS-Y5J@}-YsD6OtnbPSnClzHxG-NT1qE! zb2T%WYaC6^t0TRB4tbo9x003f%4FS0UwocRKJJ(vQ%^AmIn`Vq7L>@C3EuE2jldFD z=IUnWB4|}p`8l#gmL2p%Ok2)ef7Zj}O%9#HP38WON{Q$B{kDpE;x_dCz01XdxK>i1 z4*Eo$FZQ3OBe)i8^W>Noezg!6@_O5+`@m;IBwU~H_nk;Dz?T-H_~(Z_{pN$AX%SF1 z(c@n8T%6n6TxJ#(OX3J}tc4Mn=|z9vw_MyN|5!=R%MeRG^jRcAtLkAWWnOj^`%G!2 zV!MFey2g=+Fw-N9JYa#3h5T7mB&h?K7aYfYbJjK^ALsJeS;{^smawLNI9i+Q^)6;I zwP$Yf`bIM1Mxpe(=8FqAIqywAYfRT%==(L2&+W<8n$ZX6#=LKGWbuFJq3iO7VrO3> zM?d=F%eDwy{h~v&wagQ5M33ZbW^u*%pdWK`*EG=MYb-h0dUo=qaiO@H`e56H2z=tt z4X?s^vj|%m+oVX$#Se3y?nVGP(8pu*5PGS(40QM{W3G%q@h;{I*Ga{PCV4n8ys3o-3u)S@ zM7n$M^Z6)(b2#Le`;re0vyxZC3gzGdA5_^LNxwdQo%_k{4z`r~yGvytKUZ}}N8(Lk zDke_PMbQFViOVmM56p?a6&Zn$IjQg-$U3g7x$L0R;JJaHpH5L|!dmh1j2yh5%g=vl ziS!=oi>W-G!>j4Bu}&_ZY0Tt^RjCB6;rkgIflCHGa*y-t))wM+xLmdc_;9v3g1Ir| zDBtt`;9w2kc&3Q50!rKvdQSy|1yG2D^LhTqW%; z7_ftqnE~u(hOj#**IZk|U6YP;?f1OSIe)8E_xs}SWuu&qOka#~5Ku~eQm_o6E^3^&aTXhF``Wxj)Ss#_%echl4QJPfmr8}Xuk9&$UF z%eAp(@*>6yiRR>IXQwdNg`UKbEu`9o3UR%}{I)h4yx^K`g%vr$JMAUoL$O?b>w$wG zH8@@`6;3B}F|t}~=28?(o7tXl4-Uud)+reI7abUm&E;owvCI%JOgJBo-dl{=%(ErC z95V@-Stx^&ys+T!FuXWrM6Y&vsA}6r)@>=3(O*1q$UY1WLXC)dk&DUXE_3de%eLuW zbb|9ff0u%o?tJdvw3XjJ7R!`V9=LcboLOi_Jj%*Nhl&=Gm{=;q%{?%Z+@cMy{{ZiY z(B^F<(yL7Vtm}z&&f%D{+lZ3Axy-0(E1#ErmvN6gFeWn$_c^ZGt<6P5*Vb}jN{JlW zItu&$*#n87*Y*BqL{DuY^{4PTwerDOJ{O<5reKFhE*5-=5j*mOO)mz(W}6mnfF1TN6WoH8|1VJ#I#!EvnG+>q0g@L(_v|5VF%Y= zt1&E_dCDs?(V2ZLf7XkU>I3cZ+p7TB-_hbPn=G7~UWLtFj>*@vc37RV8mF#nk@<iXY#U2|qAUG|taThB zuUCI|w45Agi=t7hVK_!_oo^Og-KyZa^O$USXoq>_L1@rkhej8eqq?LL2#l7SA8p73 zkmH-6MPy+Hid`yk{zHs(K5L7k{^W6<#^Yg4`Y7MiA9tKN-J2b-=w<-x4)NGsoQbXc zys=)i7;n*!wj%)Az2uC@IiB^a#GyGy<)N(u`d0=*-%W>^%UBPl8(OoPp23dv)6ELR zByvxiLNYPsXBGaLA1xV0c33{1*-5clx;ZlOY#sfE;Zd?|qAfno4u(&CEn2rGr{+j* zj{NCw!M3c2kb~Pzk0Ck7fmg_xu8x*~TXq<38Gx8BT0A&Qe#$^Db#|<{=#+Tt5`^dl z^f126!1<_3jPZ&U9AZxHupo@{X2wPoc{g%Qixx#oO?oyH?*^kwo)-JJWnvP2bDsL6 zvW>aGQ|Zt;K|XOg8HldaDsgXRlq}cV;Y+(f)SRV71HPY+<0`RY&{6rwJl~$oL2hUr z4~wz%?tLbg_w1O|9-yRWl^#RBPJ_YZ@{aIza*s)Z-WJ>51fnV5pFj}`>s%~Rh0{Js1^KD7P2XmKI; zS6UW`vd;8c*2%<$R;%)l~>O5hL!cZP1B7?@_+aD(N6EGMbkv!U zBc96lQ}~?T=KViCM(*(a%)b)|%L*-7XWkFBs<3?-`Ntae80XI3svbIi{|xdD{JHMO z$>tvp$XywP#S?iy&t%R!@5A+)8b;X$zLtq^aFOf*7z{k zaP&Y2V}z={F{Yu$khkHGq49=ch8g#JxSc(gZ5Xw|%D61CJb8fawdCX09o*h^?c4il z;10vcWp51HqjL?b|Nhv3*Nz#HIM;F$F1~%5p z)Jna8S%vQ=>*PpDjM&eLllHe_#l2smJRjspcN+UllUYNzP@>d>EaPH2ba{mDv|eC38lXyK0R{894qDj^gQOoJK+9ix^f$^U-hX20!K3k#GN&a93`A=m54j% zKp(CWmc5kN-xm;uakg|JV%&A&Tvq-1Pt?J2H<=>n(fu0 z`DGoBB=USAi{qmu{XOgTn0Hl+_j7fuMJJ&9V`fO-*Fpc5=hSJ;vR+5;P6K`fl4~5V z#nRz=<|5MlJX43a)0k5o$FpnJ!TfERJH3Za#WZ?yo@e2BNEW7j$->Jcbh>WL!mC5s zxJNc|Pj(jjII~ecgJ(VSvk)7^b8K}sV%p~50_%A3lj;85orTK^X3{s$LP_%+_DE-8 z(Df{A`7H~7kK|Z?l=)DxJhNu~W|wys5;>lCo=NZHiEKC5riFYwZXsJ()9w?cl!g zWTTs%v|?YCO;a2BKG8~EwzZNPMJl;xZ6}L&*vR3Xw({(Tqcl2YDYehpOJZ*a8R<;7 zPoz?^gRSLyoQ-@P<}69CI>^=`72>Zk!L#f#i5_1j4i^>3xvOBN4QsONOi;Cx4!Bfu zhj%Na`8NgZyD6~nuL@Dqz4-gu3VBBN+!nJ+xv;xjX8S9!1150kP0q282^L>b;AjVO zS~XaocQ2FK+>e-#E0?~*d4{^LQu@xQl&)#zqUu#8C7zWMf0F0)K0dJRPrfk23)=c# z7?|RXIdkaxIpm8Cbm-qL;J)-M`|nTr;L8+dDkl5jsJS;TW->qb3|T6&Rz-WgQMS+< zH80b>_=vd#JDF3>f4{ihhb)8-^8fZi>l!>0xaN)fbG*@JEWM4tm_;4ToU0w)$Q$g1 zN#{J#lr{R~6b>FrND#4@Uzxa#sU+e&a}2&rIfUoJvKnL#fO$N?|q{8N^EFHzlXyuSuy`%0H7- zY1p%ceB(m;bB3nkg?kD%7jtjCFBM<-F=#q-6nm$lU@pCJ+@l`i>ja-o#q-U~o*tiy z4Ru-L-s6Eo~;R@^QX(>1aer^E2Peb;U&d zn8#kAeE3=AWA6Dpk)YCJi}F}>+$ z9FvdAeRM!NILYLpwz6WnQryfer1uCLsjOxvE3P<7?^6!+Jl&7F%-xnb7D`FcS<8;P-q5=ao{>z!VRy6d1R*N;JWh(qneHM4Ff&ty8&tZ$geZfbIx##gAK+$^q=mq%ix$r`tG7k)FDXD(-lrv!f51xA8`ghx9WtBj?*=auLbia5}?hwVp51 z$NS+t|E})k32Xk_zO~-;8u7LGOgxSc$Ldw#sNPfqn~UKXGm5-nOAXQ=Fhlw%&!Q^G z_XdO`{SQ79jhWFEz-RBX2G>{9J9d-#?#>#t`oOQNsljgQ_P)-WQ#HB*ZbIex`Y53+x=45dyE?!|j`pFb{ z%}&L%pfuDl(A}8An%RCbz~A^>c1nZgN`8;X6y&(2VsRaEkG5&3{*-^enu=dM*V>lN zj3L(2_8nq9urA#$yYtXT%M23U>l+Mtm_0S0H4UD>eaXiQV;)j+SPwmrkA-wLmLH|l ztWN=sexi@+FrS~VbfWT{cUy~m1n@b!w3%L0U$Pw!*;Cqv+|oaJ*m@x!%lO)QKC4!I zHc$Ux?)$_7T;9*`-5?KrXOer|@VoJbwrO&gGj|Mo53My^jPGb{1BG!ISU@`X86l6uKdMYo*9XE3b~ypEyd1Z1(Jp*K>_`Nr}k1 zj(A#6iQ6^~P#4?dG}m|Ct}0=sP$6On`&+g;;sV!pu5;{>HPaqBbsSOZ!ffgN|G5?& zkZ0upH##b=M=G%~+a5`A>}#Q`f4ivz23V1qoJW3fl@j3pTTs^ln^kT>kkv(4$jNV>q>t_5^zbq}E*KLnT72SZsi2=-hP zn);JZnG=lr+8}H{!p~I&GxH$?&7DI~$aQ3khe3$HM|ZbVFbWi8A~*4MdjHo;8;q~L z0&(CP-HsLPZR2YslfU^iI03HfbT~a-M<<*Xp}~4gb7#*>^#nAv(lc{Fk4IJs2^`Bf9fGa^q8E;ui@WqE$KKZWB+SLCJM=p3~;Aw@lY22?3#^avMetA z__;j`fApfm>}fUzbG>)(4*OJoWx}#8nMHHJbf^H;lkMj++ZVF>iXW2IIy@piK+1f=klqV^70#jyq>}rNP%DjpqVi z5ZkW+`3DN%IFyd7reEMuo%x;P9A$v(@6zd4M>(PDBy&33i^ICkGV>(+VA`2tJvk87 z(rWM=SSjv}nTfs37YdI1cVn4b9N-I|XkWa0<&B}s*_Xld{Am*+ux^J2V;v)*;<{;3 zRvH>{{OtCX=RlquKhLG&!W6DSoW8(+M?O|uEI@6}`7z(}F^){g&@?+)@J%V9>pIH( zx^}X8kdyd3c9L6j6>wcn&(;J5e(4qTW}D!ujR`v0`Jw+CU(~ARk5^lm)w#q6u4Luh zi#2GogpO=O1pM9Tw(7)dyAc7$X{o5WDveorX>i?`hHUZ}TgY4<=v9Dj_Y2TycL9E- zp! z1NH!X@kWRJez;0+<(((=8@u^nL?f;ZlOv$^j6f0R#w@ax{+zpf_b`jHZ#sfGkMtrt zQ-f=}|9HK@ngZ6c3h?@DK59?*Ew0zNt5Kz~OJRXBkK z4lLq$8~r8(y~0BAYF{XF-iDxaY6#kELf|#)KgTS`seL;5AEZkvDuMnI=G~C{ij-`$ z*vj$5F&mdwaEwUIK@GZ*zRgjn9d?k7Tf(z+9~1SqN`<-9mBuVJLpGZ@Jl3)}}6U+?&Jw z@L$|>=abvZB|})GgLh0e{Fdfm5pyyJTxG8EF!CT_JkKYe;_y(R?nUmQs+~ezm;7LT z@&(@Cbdo@q@&3L^a^_T`bf3$tie5>Q-qwlh7bVsoV2mR0?{9htKJ3=v?qNNik-xCJp+{Q_J-(%qw=8Gg!4&eHADE|1_Tq34zE65) zh?2Kxc0-{~-b}Xgu0riQQK4Q^%|u;SeM084ub^LiqRgk4F?MpIl$vQJZXsRAACzeP z(h&_gKjzO+p~W;M_OjOT>P9e9hq690C zSTdG#(Mml&xFuj_{{%E3i+cYqb79D$e2&gRKsb5$C(MjkNG9ZT7H(QIf4jYjI<}RG zdebC@+HMA~XBF$lc4T3@>10}$Byn_$muenlW;UFVX+4!FzUu^Sx)Ot&l+ZO-;m$%Q z6n$sCH75k)SjRccI?$LjO`8Nbd%UCw)X*&&5`8NFoLn>x$6vM$nQxUD>HM^^5jqvRjy zDrTn?_<2i#cYl~5irm4W=_at(m|`yX-WU4%u^voc`~qKSmiwanFkjqR6hS5{0`X_a zFZYN9xR-v~BLXhp$tq{Emneznthdq-M)pfJHkEu*KEAU*&T=_@h^NTyWpMr4f#c66 zC%HDLlN^e&lpO96-bOVSX4e zlf9CCy|DGOF9xt5YRK*gSa?NX#!Ud&)@eBU@&6k)0f$&poRWi_az~ z8(JmPH!E;{58tb7=3cMzVQ!ZnKHu>{=1D*7S8?x^!u`|62%LKqf$f(xIQ5o$9FEVy zVPqFMe{JN)&%aW!m2>Hpt?3v(kZwlq2YNadpcVTRz7EfaYk598u2#z8!Ol`TyR%H| z>m=`6bYWe|S^74tls5M&MPoysCi^Dd@*`t@m1KL<1%00T#$$f?hn(kKMvwL%1kI83$zzh19Iadri z$3CoA?5S#EFMEoWa_OFvRO9}A1bcl)?6Hv`&RrwcD)1($LeiI;pm>o9F1wO%bn?gQ zC%)M7yB|J|rT2J+FNW^(#b*uoby2*QBC@APBQT>auWupiIP1Ajo0W!bozu|wDCaS< z`E~8mU|yGdr;`QDs9+6a0oh9Km#)WTRV z$m7p6!Czfj|0-7CV@DGVol2gOuI%{^%nB*zUYPxRPO~|m?TNra?rY;7lYuQ~ZRmvt z1>GYsc5)g9eqin83VTiW(x=JyO3693q&waFl?6ziQh>panQ8Ha{Uxk{SJ@uNTyV*F#RuTthzYyh8nJq=|Y*_2V*fO1wBt(8;+YC*|VClQJ_! zFK2#tf*swAix#ntzmUCW(^;E8titd6LQwO42&VCxBKp!@dpZP>3i5+XIUWz7@7~+6QHf}L{n%;6Q>qi%19JzeX4?pRz{40Q-W6l$WobOXO*AHNS z+}O8z*~Pu*Lb8?{oKMKHLkW^(q|diEy$9@@XwYAYjCV>jHC3TjL*^p!{aCOp1hzJz z==OuYeD2$xfG)-eG?bm9I?p7iRw;&B5GdbT5<9-K^tYuL1M0TV`YP7=?N+@15(M$Lz_%UaoDT zuFiY<|L}~XyIY8@vPfdDcwu?1a6GI}_xB#=$n-ap$m50bJ3V46U$aKF!idV|xp89c6QO-Q#_Ib#5F_T)03&mlaC!&{yBYF;bA1CrDm1fdlXNk0b!rFBs z=EMHRoYO9O@Ne2drZ6YE3w>wDis)yIWlnA)`@Gk;mBTd(<)xK7UCHEqcBkOT**vsa z)lBBnFZSmkPo#7U!^$T{T;7p~PrEwExe2B6gRfIQo*W{1%yzSLq4>SEnA9wh(OXyx zw+_QK)}dBz&Sx*JjT|Z|mGsu0=#UYP=ls6STd+^|a9jCzWRbkS>kiA4VMw{1f~I%K z10FEv*;=XW3G||~I2_v?Qqf{&F3Ooh9aF24x$3ODE5f1fmV#Q|tm$U9mB&11_?+R1 z7hA&6m0ra-b8?+0Y-Hz%5-C6C0WCSlS<8&5bu<@~6>X%>#Ug3<$rD9U;duLvJenDE zLi(7?zy9POk9cBKGYv`$jkt1|ee@>QGB~S5w)dy6Ffa^L|46}$i_E7!)j>vwmC9*y zZ3$8I04^}%W-9rnVeRG1y;6xj;fYsWI9F{Xm-mL8-RHJa@~lKcZ+f5=`M9D9MzkE4 zi(SkSeppf_XaDlTd0uDwz*H25u#VlSos=1V$+F$-^G;-LFMqC*KXXyT#ZrciES2Zv zK$Y~?wV{WxF8hX!JuF2PUqnYdGo&^#FZhuW1Hb3OGq$x%EG-hxL)@S4B;QKTaZ=f5 zoJ+Bi%MX};O%7|ST{!C8Frdd+UJp6hG`k83c}ni`MHnvRlfxoMIl7~zZ0N?d!vrrF z$jOHA{jvV^85+A5^pus$pxIt{a4-zkt5RUi_tT}E_w(Hn>DI*qPF@3S!olmat$+|qObZ#eZZ+SmBk(=Z1{hN6TEO_2ga?)I;%_@_%tJ&Xime+5` z=U1DHpeOBQUrvb_mU$v#CEXPo^1o61{~v6ndv1wbY3zYSa&STQQ*b;Yk6tZ$1GVMS ztSh;>A7RKLC;R>ZJ%BAc$b_cl@}tCq4vjFhv^8P?*OAxR6Zm>SsqA(4z@=Dni`!Dr ztOdF0FYToBgJS8~g!$br;qbFGqM0xKl@rWF-?KHhJT zEWPRlO%3`qc9G}h_Z{%Cjo2iY%8OoJxW;kjVO!>m&(346i>35-E|Gh`=s)GSVT?DT zoLu36*H)6OB4@YR106?)V=BF$(TY5@7}Qn{q?gIkV;ryeTx^Im;5R-;E$rHg?PhtY{~fmzIe&$GvqE$TKDz@#j?L5Pc*s*`i3Y zR(WG1&(*$NHsIv0JUU6*$;hGPb6fM=gPdl(ixI}%^i-BxNQZ8fQf-?jc9I)iy@-Cv zm$_)!tfh=otg?j4Q=wdnoy%tcL}{T}i9CEt&G;O@~d)IDcJ)TPgOd9HILER3@scyGvQ*YP2^!tGvC?9+JvROdgg1GdKID=bOs>MdW-+p4 zqaB7!41^PToE~AUsro9^frDeD`(is--wQ?44w36=Rg?XMW%202 z+VZLmm1sl`v2d&d`|ShpJ~$o|Lo(5i{T7!G#>rF@J36aYqc#0;zrJO_X<8L-XC0I2 zW9%@{KLCzL z+F|G6Kx`#1Hu3jN))lJYyf0d&40k|WVIXR6(!psn`6>P$3;8-4l|3pN217MW3wu>2 z!tKbP#zsr4*37C}NnUlD79Q_1uu7^}4~><)W=fpe&m3f9Jaiv2&^VaAoAkIfBj5U! zez(-Oyq_Jjm|el2*EddL>)W9#f8NF);_*X64Pqw7B+H2Kvoq zzV_lMQ6ICz^TGgJA5X4!Vg?p#D$)K|jO=@Dix=uZ42a`>sLDdUnN?8tix^gy|a)-zut)c z$K~)Z8+;xfi21+b;iJt&M{=4Dbz@{zb2}`UOrK_YJYBEMzb>XOYs z(toBcWKs~m7`2!~&uOn(^gjkfOU^-ixYi1ULufp1X)~bMTZJh@VkLp&+miG^6muLK zS&h#-`QoSd{yP`6LCg0+Q0H@;?460S$_fm77$udR?2wqX8hv=3kE%E>@p;U$i;-5P zb{M*YnYlgb{XCh0LUN;R_H#TGdj#-(i}a#*V?qYa>qTi^rO?w)|XyLdSf3r+M!)1 zdT*C#vA23A1|6=#zkkI^mmTDJvjX5#iyjYpa-XlM!t>s7;(g2>^)@jdoc!Qgjx(EC zN6dN@ClkHxVP6@5iq7Q0&(q6xs)~*-a;!#M^d3sT=O}WZ(=u`I0N>A!u`+VMEt>Lr zCV%2{u|E^-8df18EJpl8>@boX4yFt%LX(CD?x)2*pvM`P@v?S_o@ zwT$DvUM8EFM;huMS?6YIJYi@w+tuy#q)x7d2koys3q5BDe(i5?JiOG9-?)a`_gAHc z$U5H)^INwxSZr%-T&G)WsOa&*2&`6bmY*lqdXcdArjLEx)oM1U%GPEaVcc( z_r2ROa&xOr9F|HjGZ zJI7_!isN!XwBlD7FZDxX#rN%TS!$(~6LWMjC@oe>EO`drf*zh26&`+Yz)03Xn$1z- zUmtpKk~`w^6te9_^a8McbI(NukAGCm$WM?y0>v4auevzh!{dFBK|C5Caob&$thk5Tj zPk!gdnw&ZtfAjppbV?QuCuMOQ%EFmVbPe$Qz`t4!>b1y1tK0myD_Pja^Nr?4_I2)N zE$vDszAVq?zh`4*0lf*V>nnIZ9de%hVjMZgx~!3qeKgGE*;PCC?T*Vr!B>8sXXb%E z^#5?~YPGt(7;ZaB`h6u9!aQli$I zAg5G;^+Bwycc_%7zndVAxwmaTSI8y5axz|(QX{xRCM>8DllUrWvbtP`gwqqht3njt z%VgjmRrK~(NQoQI-RCH9{Vg-BPn1cO8SB1d6=VS_#W1;2+B4_c&a+(pY+Wfbu!!g~AqT6DY|^ntaLA6(DT?Rd@)6Kne-u{!JTTYQi@+#5BxS7|@V zAB(nlqwg0VuGjq#(TCpoS);K*5y4Dn4JvSIPU4zjI4F+{2 z@A#0lpRpP=U8cd1U94A?(78xnu?Ej#K65|#4?o|%kSqb~`{$J!EOjNX<*Pw&@{bi~ zc?J=rfs1tnj@m___W=6lcJOt!vF<)Bf?1&&d~C^l-S!b!(2-nKhg9V5NJZaXJkQ>h ziq~CJF)l6@o$^yK;XXO2*D3h2iTz?^AD6kN;YkHEOnytlgjMtlS*9Q{lV=?fny zJ%#7U`M|3@Y_iLT^}Bp{4PsWbZ2{{3l@ArqCD!+4?Wq_21|#TK;yH?4Rz7|omxn3j zr{;Ad#~4ShaY8^Xz;Sy=DGozdRh~estRm@>sj+ z{o&t3GV(BDGqc1R(c{S1vEqL6a;Qp1PP3NjgRR7kz07l`*orr~!s9*3GHz4KzIS}4 zKHACc6=Wbb*ocf*$*IXIajfqo4_;VG8u^IdPrArOCmVS<*j7U3wUhacY^7FDM|o(c zlG7jTrE6PDsZSqN+Av#bIk%nc$Y?K5W-6u6C|mXeI!OIQE1B9^DW~aa?6s^y0^TUl zcRrtsDHUS!vPv!`C=lDl1XD(t;#%t}c{aXEY%W*Go;u~S)`nS~-z#L}=t>FW=a;Ri z2E)xNX=70-m#0>U-l{^{^;2N8wnCoj%4H<~Z|4bBGM1mu{81uJ>3MwnSb;E4G9{%Z z@ZrDzeXUZC^Yeddcn-9Xyzf;X_!)gM>W4R0^87I5Fmv5LF?Yk3XNVWbAM&|rtY*IZ z3LiYE@J5=m7gq3WsL4?ublBhyL#Q`<)tI}HNx$L-AG9g)LB?SE8(*^)(2Lok8;;`%;mpF&z+=A#Te!Dx2n~)-p}XpqhI=bMR}m2idc~}1K3fVtqZV-* zdLdbpJ4ycHGiw3b2n^3+^`GXIUwSbaXn z$NJ`B&%u2Bm70$?ANgEo=3(x_JX|s4GIxuaa3Ag%cADE5x_7%~*tj^+psser(A4^s zYlz7xH{JC{$t`kECAaf$V%%P|J$b=<-%3+3T<>^I2R}WbC?%aKVG`U$4j4!S~+<$R?g3e7hgx6$Z?$*cPU{pMulpY zO3Zv`kIA!Dm_t6MU_KcOXBEaRwMR&aJsu3=+A&m#TVYBZPgY`*nF_tr`LzeRHay_K zQ!5ANmn&gg!TeLc&cfYFm?!Y_%b8F1Mv1Zs4sg^fvCKk+Bxfh=`BRCn?RZAVui5g! z9<|;pG3S*MiF-rQpXhv z%6~KRtdwifo5zB2k>_7N*XZru#P9n(6uXT&Y~^}wL}&7a;X3@>^cA67Vxehpc^M z9J{c#P)~=tdvw@M_Hf%V9cJ%gX6Zoouej)NErva!m)X1WMhlDA39!=Zm{+fZU6>v> zuhQRGhk4Vv+_z=u@wbg0kKgLpyTf(hb7qy;>9M#=0v7SC>%=)7(#euE=$3_kt>|UU z&%(@kWDwo5kb08q!@+dYG@+}JfB*MlHYWDUf*skL{O|N+)g~L%Iva15%!vM!N#`tC zlSJl9A0eBg=Q(f>x)~>AF?I*a2B7uoj2M!M88!Se&;(mAJ$%rnKj9o6V} zrss-h=80FyjIZ@WlSw|fPp&cdj4$*v=(2mDL5tdCyW2&w7c~M?CvmLfm~={;ik=JU zwXm=;t{$_4&FHrx6W5q$`eXJMpm~o1981f`&w0$p z^x$0VZX+I1f2C5s#Z*b=#!9hSUnR*~6v+KbADFEP_HFRP_XU2iIZW?& z3qMpw`6BBCGnUE7*piDodo}`{awCv&GZJ;Caot6hU|S2i8M9MiHa;CoI7T-wP9-m1 zfYtwU+~xc7?q?qAZZ4oFr~p4Fbd=AH*>mKml8OQs(OIjc#`#Wix`1x0am<*0R3`Sv zO%c`B1Y--UWKdtSC`Xu~Oa|k!${(2LhmtWqu;84vKaA_hDa=wXqBEG>LySb=X1`Pn zu1)@fbA%P=pB|p+7}AHoJH8hYPsn?&&c_EW9apCdaB3ZUOYU@*4?msd>0)PbYt~UB z>d?D&xT6fYX^Qim6gYCJQiRu5AI#+Dy)^Z*F9z!U@zT-{8s@6jEcHd9qaPX^qJQjO z1ap@o&^{*;i_b)0YwZYZ_{I6Eklt_GRJhelL!BR~m={HVaj!49bcbs{MFC9a79ib; z@6GW7`h2>`RPHy{=Q&HGab0Ba*iI69qlc`!!?jSF0|<7XNUEud%gb}H(9 zOv3=LbU3OCa6h2{zunKrfGcD{crO)h%g6I@tpxw0m$GV!Vis~r!ke9xh;H$+>ZuA( z|5c&yLr2s*paQI&@#PouolEG}^9{u}?v;CbhoVIpeY46?Jl??beDeeh?3xIxa*k6T zdVHVA++dC${R6WxBq|#nreq_nCK(L!aqY=|wWNPAaK1vlnQVyX8HKtt9aFp8CCISg z1nJ?Vl^Tv(@oJbPvs#kb``ZzdBIvj3>WC?>DxCl12*&{`EO-_Qmu{g@#?kXv6^d4u zLg9Wo6s!9rpnOUKj=g0*0r$bC921{4;A}EE8&N#Z|CEpo|3Nu)#b;v`d6g4WnT@$X zp=E9WP`VHo|D>t2!L?*8OBHG@na2BC`WYim%Hlthm}Gh5wpR7(Rqz8*2w|caW)?jE9otp0wkkTa)Wn0M0R7=29Nx-*CJPS3{Z+-!WSlf!4t zM4e8Kh`9-B#T$jXCtXrW-A&X3Iws2TQu38_Q$L!TB!M$d$@Ad}vizbF#($jPTi+Qa zd~a-5F;A5Kua50QaXKOt9!<#hI1$d!Q|4q)xkN5W}vMRy)-(`rslk6^VmVw)q z^5<+DNj7(qvRkEc<7bsjbXU;xZi;d{6IhN>z`c(j{?z&4+G&5(X+v)<$Llj3hhFm; zzj#K2%-a#nE8{x;WCW%(iNFm@KI>!nj0dIT@3CYVyK!u^PeRRPmo^x#)kNp57N{CeVt zoG@Sf+tm+26aVux`l0Vw^4^#D{pUrXJNFuWIFHq~j>Lkz2o!Ef!<~RM=1j1!@MbDJ zho)f{-N(Pp$isqg_76p~N8lmZZd0;p?gi-c+)=g$sAS0Dtm+Ry;Go zT2p%V8!9mSyaGw@$)1lgVXqm-F;BTA_mDHXSILzZ3Y==i@p-%{2AP@QV_waA{kB;`Igi z^pe*SSb)i;%nP4cfTRyD;uG0X`hV}tYjP2@EzXkFx|4W+F+o1}&Gwf}aDRje>|U85 zb1u2Yi@vxx#E))OALujKOL5y5Z@Cr<3}EeMas--^8Jw+VUU`Q|6zpLJ^@((Bx|fR0 zWKSb_?_?ZFgL}txJetXQ;w7EFKiFs4J0BYt6`-P70W$w)e`2zYtY!xHqI{KnrPk&5z^QV8D4rp?*4vYO!Jf2zDha)g&X#`pY zl82qZJdc&^UEuzAm}5HnbIs$JkcJMA$-_paq4Wat%75}b*;T+ELiU!F6=3^~0yN5OSbIBS*(@ha^>ae^autR)Tm$EaAk|IQbzagr0UPfAS9hg1eJI(qt~uBp&o%I)984UajrqQ;m-fiP zE-Afk}^}tPJ)0n0FHY!0XU+d-8@+2{HjhFT@iE{oH^X}Jjk5jE9 zy&@{CUE+xMZB^Lo6Ux142)1k1;FD)4yf=hmR@YE0dacLP1MH&NfoB}=)V=LFWQ z+4o5hd94-OnpznV>VzrZIiD|7!u_fvs%k4SYY_Kdbwe>QAe85wp{P;7zAle7_`!KB zkK^&Ug9#XPQI8}tmVG%!kJ&`8@9)`|wun7XoX2i{;d*~hHZF7CICfm2#zCI{b6j3A zPoXYvWTKvHZlX4I)5-Um@p7Vp(V@#c z&(1-4tsLC+q)&4K&(6s+jyX+VB**D{oa4_GkwpzjVy`V3)VKuk=+1tQe-p*iBT;M{ zI-)}!9n7b=k9F*s*|3S|X-e0_~w)AR#(__vFdI(s@uTb&# z#C_MmCcL)L9P}y4#`5``*VmH$?4FIWZMbjZyp>6Qu`S;d)ho`Y*A!~kFADWhC%s6| zL@9caDC-gvB|AG&rr4j73FS&0wsmC2gcC+jb0Wj#1p9i9*xNW1gNKBoAd+h^w@~ao z7>YNXSHFHuK8^BV)IJm$SHT2?hk__Ili^5;jC=YQdT}JmctW0ko_KW-%pe~$xK1v*4z`f#ZOWK8?T(^x;W%8Fg6`xc*UUDPC0|RVfPKOD zF42!xYDAAf=E+8xOYd1FqU=DwnA2Cr7)Gn+Z!wjSs-BMc*U7_r>*GjnAvnFn1gD&~M!F9^fEz4X?-r|-w@fA)J&?RS94V~N-7{qmeQpbBPj2y8ju-ab z2}8wFdMXFx(obP7`%jSvWUg`Z9%0xq#ei!`^g<48Bj*~@Ygx^U=WpTI#rJvVe0uR} z(3?5BNLH46B9Z3;F>_hp8^xU8ITq5oCcTy`=_?$mL9Ha_dXuLc5N0Mt_e-Ql8*-gC z;W(X0|Jn`qBj@p4C!$2EC3~=^H4N>9dEW_nNbS{DW|)*o12yw-FNa|+>-CMl=c083 z3z@f?*$M2!@cP6&ZU^#H+qrMOO`l_WrCh&5e_vG?e21ivRby}S5i^kkr7|l6kJ-H3)>dv^4s6vW%OxJ_@#$2dyGCrKXO~O z&7{xupE933@0-`;;K*}r$j(I@V+(mbw^*!n>}iap*Rnwh;?2l2wrMLa=ZeLNu8MYi zUOw((?e%Id&T6fB=2a=1$V>jm1!sIU(gnlci=O$vU5jNs^V8jaqZ5MMq7-~W*}mqo zF}F;{KIeUVJ{;GM8reUX3)74?GR>)6svjmVHi6vkp%i?I;d7)h7cbsd&B8r#lsw?J zKI8${F{hjU%KeAwIVG<*b9ERBd7rCV<>E$7=6X*e-$xH%@&M)(ml(0zoX@+ok!D-V zq*FU@Its&Zva1ogv3a-I&-CS_V5P5j;D(#hS6XnLKJ*A$2x-!m?R73Zuzs zhULP#cS~7Pi@EL0Uw+8@ZTSxaPMGJR%a5k=y;qqu4D!I~1aicmjo3z?MPX7)`Fm=) zOrr1d)JFOfn;S8#VIGohn9H&EWm2P^2fS=FxWk{T)5lzdwdMWUw@f1AJn^fTo?HX# z^P}^zs<6GdA1IU$Px)N9XwcKdh+E#wufNz%+BPVZvss>Sc|u?3^c0*-BcIr*y;#gC zmOPCY>OKua(R^-H|TS%>NP`|?VG=kN4&uCS7$8ai5RJTU7}IQEUE zCwCS3;t(t8$sF@L9oV=96;rL&q zy>(Pu*&DVUsQc8YQ7@W6sSC7yZd&Sw*WKL>3zcc7-ePsZ3Q2&vCqUf|lDZq#c4}CG zeE0mm^}c_6|9-R9tSK~vGbiVqz4x=P=elJl_ZGgBFQ(TlVW=I79|ps=3%Mk6F1t3D z;rRGi*}K{nC+TI&p)c>_MSA@fl7F#{m#%U4_{bdI;+^Du$lpD1H>1+9I9Wu_CG$Wa za{Us~u{Z-ymz3d?DMkk8*de}C5M)Ur*7l)q%TR`-zA@5nu`M%a$a9f5EVIbOf>82G z%i<)gqCG6n1Yy{YL`M$+;BoO~h&LnIHX82HcI2wK4Ya4GSUr znEg*quJOw&X6u&1f=?IkqS4akL@(_30yPH!~COlgeQE zb-#qf+wrx5s2Z7we$z6c@G8TBRnZb+wnu2kK)Cub2lf*AubK+?$K=TJob0f2XfS*d z$O#(B6_O|VMZaFf3#5vd2(`zQH>)sgJ-vtI$o?)dGgmHJ zrjD`4w)6DXDH1U_I1_~j%@{QLuuPyAvW|5iJa|4ol2;nwU5eP~I7uC9k4FJP=*aUK z?3Ic8f6+I0Cq|qX+2eT^a)RaPdFn~-j66{dQ>;XHae$L=09sDbz>S>4w6{TLIm{zoS6J~HExAzB`; zu*JpfAe?6{e==*{M@(k4UVBJB8ggj*K@HjJ_3`e9% z8wbof9srBUe4m{e@HuDZ^DtJNn73QLbQQ+$(vZL6^?#528oAx!wde;-qqni42K}C9 z!tEV%jn5yJIhAZt`Yniki;2h}Kb!p0jK4mT>ntXRyEcS-dE{Q5=pZ1+y5L7N$7DOa ztU&)Jk8^JpxlV60UR{otUZ?0)tjEuV*TeE&?S#kkl&7%!0j)$;nhS%#X!W5x0;c{i&d zytN?*L*CP8hZzZO(P9~557(N3coUk4ts673I+ota({b{L{OKI>n+{i*i#m*X$0=qk z4Nj23o9u9VLJ)8!5$V;K^V^^dQ~2Cio#TMcVFB#zPsGpB8R+9$2Gv`BUgQ}kw^@a@ z;}Y>DjlRM+%qt%dE7R!pTf_ga0k!ELG|~gBs zI#${rbAT=Vq2~h-JT666%gL_ad zekR~pbOuKDGs7d`u#9Wrh}OK1KE)@{UHu4$x|=cM%wgHwn%7SZpEKRa&AHRdx!H^* zk7A{U!WJza1><)!=7F^)pUC&Ael1q!lY8}j8-Vy)NZy`+rlT_Ojk(*0 zuf#~zQafBY$MfmR`~6o2fWvhgZi*cRq(_cm!k5 z2Mu=f^Bq)$JfOr0X4+$W+h9cAN}%hJykQ;s9G&9i;#7M+7Xz`eNg|r|&%}_`sx=RTzsc-)_b3CrC;W; zU4Pl~dXMG_Lkx|tPSiJA_3Gm7k|_PI^f-N5q=VsQtkQ5f@4Y^ER~y6MxAQNqjyb4r zy{?BrQ8>y_$!)T0rq>Sr(0L(l?-!KQuR7I9Khuz}pV{2`VvUir^`rYIx>cF9PH$VU zwf;EkB8OWgG7mIKCQQ-Ez292N4M~vbjz^@;eb#g6Xgu~!E8~Z;AKk2#hX;?4P0`6G z9kT4^4oR|@jIIP}7qnhUnLIwSC?+C;$E@}qgWT}TEh|Twkc6#106f8-PcK0 zV;O7Z#aEdDQC*ED&D40Cug2IFA*}0$u=k0co>T0r>`pHL>qtg#?m_>}zWm2(IKN_V zD)*#QKB+N{H34H4H54D1J=l~^oiXGcr-agxqef0mHLC4q|LQF@R(g<+e5l4Vr%+fd zW36Qj-(#Q}jV5X_BvFgp`5H9Q|L5M}7;>9V#d>sBaGz)5GP+{N=s3S5=eSCX!fP62 z{iZLv0l)sC!7kQB*06q6(o%~tuH5fFNya&pd)U?JF*vD(;tuOv949-o-u0aO5ZNP` zV_la_B>xT6@%Q%DK&|8b_KEM?UW+XD(02H2glVY}wd>P8O`iP9Nh40%nxNXpI#dB2 zIjn6cV!2;EnjGUF^7!0e{?eR#*=yj}B3QU#{pP~btYVrk-B zDvS1;Wh;C8nzS$dUv}-YjU_UP`9JONDlpAcfsy>aTYv%%LG&{2uz)JnET2A>%E$K# ze7{CM($WG?EK6l@7T=c+xy;SXFk)@`XiYkF6c&i|RbX9n<^=_FZ{F1p-i!Ruw$vMy ztNY=_A|K=*WiGDK4?|CSqgJjDru{?j8=0%Om$>iooO_*IyS)0ytlKJn?D_P=>QWzU zYfjh07GFee_Q$_`pYd1y;MHd&8tDAcZHGVVlY3nF$Oq$k`eC%Y55~+G0jsXeaysLS z`074L-NZa6asWLlL}2r=2s~dDfqBCGfWino4Pw@9p9s8Uy`TkaQN`RBA2}xyKXb$J zBP$#uS4UvAdnB&%b#)u_@44@KJ(+w}qez$rkSpM8$B?ZuvbKF^757BwPa648Bv!jJ zuX-zea=*!KJzy4ZN4ghmBT(`$vx+9BVNF3QGOg2auRb$v3(`>AJ{{PS2D?sasNjPKk6+SY?2-n@_v``N z!9D47WFZ5{V0B~G!n0Hayi7yAKFrz8PD73MbUAKH1$L#;mz@Sv{anCsvg2C`tXDja; zhpp7~ZYFmYDrJVEg#;#$vzTuu@4C3iUC&msts}joRTQXN!hQQ0%nuu87T2K)Je#M$ z*ipPs>RZBGM}gI^%H*z1nG8uX%aSn)^xvewxe5xDRW-}Na%HmVCij$*707es`)vFp z#fDOu=0R?e_gwL5=2V|zwzP!>2IVQRbg5Zl+9;5tHjDm*1srQBkZ(~cH>#QC=O@-b z$R3)wPnYo94~Mt=VI=R9CqsPk;jAxCzGPi&sW+ODJ*nmG`#TZ5mIE_qVRUaIG zPY&cXxtSPW+;C!+dw*Z7jP*f-W_}nG#|-x_{s^c&0$&QrM1J(cQnep0{2=pK$sc|N zeo(gbqbJRmpSeHUwerRL>QQhda~QrS0y#?}aFEyexu+3mefqz9hWE(s2wWj2Tu%{+ zT8U&7?~ont%lyj>=1M?30_a%;yq?pH%P-3 z=Tz)ZNu$Fm4U<2R8{&QUAtMbnFQ$<<;-1=%R4gG2@__eT%ok?Hze+{(>Et9`n7ew9 zj#5=FbiAkLAIZfP?;PgN(Zv8n5;zt4K~Kb!9Gc{ODY5PiIO( z4$7tEpdGp5A8*^*;J~o%Z$El%3h5ea}Vupvpt^Cw^{s>*L>Ef3C_aH=VQF z#e)MI8q$ZnbDI%TC4z(kJ{Xy0Gfjsf+R7yBTUdJlB1Su2g@zK`Z@* zsJa(x|uGs z`5YOIwdFK&C6q2kzIJsJoh)dZD92AHN=;+344RW5wr7&$c4C~28l@2}Gp8?HrhC!j zh`4Z``HdM^-v=g$=2?QA8%dvqU6Q!ybmIJ0Cnfxyw>vtbM-_5~tifFNcHlZu2^mdx zk!$efmz8L5PuE461B@d$XRN1W|D+?1PIbcYt&Yg=VTV`M9r1ahBa$mC5qQ%P9y&*6 z=JD%1N4T*6WfotTbb>jSLse+O-kKj}O4tnM*PK6IZb%Bx^*x#~5 zi=pQ<7*LW3mj@b@+|^=cWi7LuHAow+MGohJU8ivG^}7ZYE@{zg8Z+2B>Yy#t;P6fj z^zK>&?Bo7ll9v4wbWELQHd}oy>IZ9Zsu^=NBl$CJO&GGlgbXjv-QF7EP-4VdfBF=c zaNW&)xJqOdOa7sA+m~F@4il>98*!^KSr^t(3@-G2%wc}?6eH3uw;8-@ewgP^KEOBZf-3#O%h7Ba2*4h%CZuw&uT}k(su@_^x zAI8Nni*hVoSEdM9?}&imJDs;4?3b7s3EQrbNKT+rb}_kYKC9lG=QGQV8ODL>m}^f? z?=*V|t}@$x5jnzVy#GJtV*Fr7I!c@*Ylp2YEq0K)+nAME%~_(`TA=kd3zV!P7iVjU zcM)_CJ}ZYw-O1|B^rgeyAJdkRnGf>EdB+jhG?l;KHWE$8(yiA%5>IWT@Sbz28#`h6e=1tasOhGs~86PqRzh~3=_m;WJ7U@{}B^N%Oa&U`$<@~mEIW6P- zryv(C#<|F-qhwEGoFp&1gJjxvl1V+CndxSU#(||W=QsVzF60`GW^wya4!KACFyfvM zc6s|DgY(t9x$MFDn$JU(A2)i_A15g4d0HD_q>^gc8$q|EFlMbnENC= zmXT!~E3eXXRmgnPOU&k+lOo|{+Ditrrr@fTPAih-zntJ92b>T_=4)^#W_CVOqOMAb zI-}Jvlfh`SR*mnKLQ#8SD6BPV42#fWMJ*lHFVN!hEFIR=)S*^o9q#1O`5HjJ;Dr%0 z$fK=4!hQX_%n(jdxPJ>*xa;X3>_aZ326?%ToXyfoH%&6@ z7b-k_>`2Fe5>uL}uzfS@1s}*h)aBa!lp2HL$(55)i8`Rhtz7#5)@bPpNR_hXEzk?i>y;* zfEDv7|4JY)tdaf=Q^auz$G(3ZvGO~|n0n-8PAf5@K!sZEoLCYm=Q{$^G%#>{Ngl0(<0LHx@pIEJ(PGyC@*fo+ zW4_XaiG|E!xI=d4AlLbed2YzdOjxRLzhG_Q-gT9QdzVcL_bbN}$aHJv(dZN@?Uf|| z9z7~klt(4jTZ!mMCF|qN@aX6acsC6dpSyU^7X1#-f|A1j#uH9S%sn{O59kW!WVze9h4lCHwB~o zEj40av-e;d86KXWBjk0?r_)=h*21$;i}k#YcJS*7tsmnkxuyVmwk&R#(2xAgq(kJK zZqm^fpl~lB57PBIxf${*Co5RESG=K=%d^`{xd5efDppF{3T@=XPX`&SvqVTMORlrc zGA>DhJuelw%jfjr^}gt>;Qc<2TsPMyZ+`kCl+Wkz3-s${b3L5PwRNK?JlY?D`@G)+ zL+G!&mX1X)(lBrb`;DyA5&t6{3*Y79_PIPPo|uOyt`VRAlZzwTJe;$1l&xVZSu@s2 zM)hkgo|8Ju3%#>ghyrIV%K=9%;5CFE#JL<>c}(Av{ZOGi-SsU;Ai1eOet%4GN zpTbdr>x{nkkvM*znF%$b=%=M~Z!Q_MLus&%Psd_DtF7Cl?*FSS;rYewsTyWY%R4wyMFZfH!Oz<97B3l zr7tqij~ps9r@4-LINcvlesMk3m$}zXqR=Fo>l#b0aS9`m$FVh`=_Tyu81ZglI?BqW z=i>bFJlr3Zi!M|0(EKv_!7{G%r`wCg zIY)VVuDuv$x=7<~9b`*=XX#vAD%1N|AXY{0GtLqlZd>AHEZ5K6k2hZML+xFDST}@T zL@oRA-uc0X^_r3|5!hWV5*1j>apt%>#gpqqj$Kx3(=oYYI@}%U`V38HLlt{Fo9AKJ zX!<<)xizATdGBKO3*5@XntBe>+t^;xySA4d&K+cauXbW8>nQhPEzqw^IeNa#Qgx0c zb{(_C%_0l*sKL*QYu{Nj{P5Dn54*?vVS6Ea1rA4|71ylmGFa5MsQS1|n#F<6u zcoUP3;~{C-Gc6s<+H$VJYwG19o)LJIW^V|Ba@#({+;vm(H?wWuTwMkk2TeN zvS?)SS0C5Gw+ZiiUoA4%nb=?W7#k*=;QEq#i6_{*Gv0)q298^GE!=mhEZpBPUtWsM zn6}u$-TA3jel1UuAsk1iStrTo@5wUtXOhf+r$Y7xCAObbB6m6cjEkJ$xK7DDpHMu# z5rP~YS^NO@&+~abp3lc)7q#dXNY63HjV>WN%$`l2`Wt)T?-=oUjtN()nXvH(>$$_p z5Ay3VtI1ZLQ@HmhtGAV2y~rKp^XWf+#{HMa4YZ=E#pBXw#jR(OESZ!dtG_$qZJ-io zE4Rh6I2GAmC#;yn@sxG&({0qKd`u0?Cu%5LgyQ@qHTJe8Q#q02Y3(G`nxn;rC@n%m znL!<7!org#6z?&i{V?{gCmNA>pMCD+^Gwz zZbzVx679&rKHQ{2aw8R%_^MESM+mN_ao=NXDBhIPUrAoq$}$x9-)XUrWBj^}TnqNo zVtO+j+!tvvD&jHsVwn$ql%JI&-NMJ%gZ6>7e;;})ds(>u;e4ZL68jeJDcpCgu=u}z z#`&uo%A{$3cZbnVss1PyXRJQD}gQ+}VdK4JCYD zf$Z(#1&`%nIN6_my=vqKCpD7o(SKynXm4~Z4I}%Rim3_Y96jpFwuVLGJ;)QHVm>dq zHdp&>WL2y$6}1I2euNk1k|$byo*dSPY+PcmcU;pyQt7rg=H3fKMN8(r*3QQ5Z}nx$ zi+nM3^F&4${@z~f2Tsez*^~xS$edYKh$me+JF#Lib6Ux1Zf#UYlw%7-G0qb)Kgdh+ z_#4j8#(;N?WZuC-u{gxs>d9f)&f}@@CJWP?>r3lP1yXQ&I9$tzb4^N4%|9F2#f`=9 zYrcGCUh}b!;pjWkz?5yqE*q9V_*6sL%e?P|)}EMOi}lF<%nk3EgH=ncq;7n%M7?E=m3-Ny zs8n(RIoQFR;w6!P#NR|uU*B;2wob*yjX6kP)kr?l8~D)L2SxqEuyY-Ke>ThkpVdlK zx>C8?kQr6vn|e1&MU^($P`+#|8xI!9UuV3KS3*9~U_jL0S(tOFfy^f-c)1sIlOvg< zy}$sQn_1ZV!%8BG@?~g8Z?xh0{I$b?){nDr&7+ZYK2{{T{@#f8A=mlAfXd_(N7ij4 zo#RVI*V_x%FYtKgvd_988`G@Xh~t$asn7i43YEiA%ZfbU66P<>pcijgiNpjCN9Xu( zEVM|azdjpvuGW&0cEvJ;dnzlK8=l^XzRR2}WGLE5rH8*{5zj+~Tj8v?7?6~mjd1RU z9uF^+q;PNi;}(WnuJkJM_)BIrm77`la(uTZtP>-K{wb+m=9|3`Fh2|teN$0H{&Zrw zx)QmvK$`UBeXXS5&?6OJmE>M8)|NfP^X2>iZ{+j}M{~0QI)4AjH2M~Y|B}J4J#p%D z7<@h(aNHvs|MqMkhsV(q>Pb#El-HXo6&dZakwvLkgkx^D=F*B9o1PbIHzMqZcc}?Y%;~yFG-V*`M!|<#w{hr6NVV+!Dreqe&&80rr z5*3c(r3OT_&VtLk`f~YEf!ML{vUX4I2^Q($!28bSNzCd=B_reLDpF_P2I5a*R zW1Ordv-}@9GtGzjN#R&pV8EN=Y#e@QBgP+PQuQ zNv@JS_`_8A?axM!6;@L7^=~nE^gUl3pZ6r-ukrNUEi1$P*3lBz)&WI5f>30g$ee-E+@<(@u z(;qkJu-x5khr0uUaB5m2j%qSk!zqK?%xL*F*A_O*gHW$l0=l(fKF(M2J5}Q44!wBo z5&{v~AOY{cXJGsIGPvA5B#+zLVV*h&iXqGeCKpz+kNLdxl$9~pI3b34!JhOpE@m(I zrZPO(wO=}ur^})T?L@6a){8UgQZl30@@Vnw$Nc3rL2xDyHGtgKKc`F4z$sqrHrZnK zmHi&xo!_{{S;WlAPmTbPmAh#tc_wy0&ILu#xBcVA@SI{C_xD-X)G&UVO) z3&Jt-P`yTyUvo6$?b=wmk!OpByw)nudoZVGP|B zJU=OXeVw2T+?!{H`JcnmhU@Co{j<;L8hgdE`B#Z;`jXT85VcW8@RPhp)Z`Aael!zsiwSX>UgM;sa7R!~tcF zfrwM`ym=bo>{^B;nge1>f8yk0!Dx3h5$`Oy_wl(5KbS*pqOY)ue;{tPVa?B!ff3{! z+j9-({SvQT(z4r&?PEA|gLfvMzV&vlCx2P@_^PYK4H zd5L&=H3LU@{S@7c7Vo;`J-IfW+?$@kn;95$y$l{Z;>6m<9yjToT*mX0xskji`McX^ zqh&as8^b0B(w?j#3bV)h8WGaQjJdnx zBxtN14)o@AHHO|&zYMHzYsS>{Xla^ahoF5SSUWTk>qcgxOF$VO-ij8{*`xUhX4sIY zsvnqvCw^tHR>nw`2LCVrZq4)H6+*x2cRq*5#z=#Q_E>u}5H-Ct$X-VuZdY=ttKwzX zO$SU|AB0yY60zxW1}@n%-)CW*++R*_%Yy(kcG95H(Mk{g3tOtKInsuJ20!w;$%BP$=T}UTJZ(jtKwwzkmL}U;lr< z|KHF2=LYdf7<}RJh7A4C28nu?fM@!u%^SF`UeZ7xdGxnFEp&MrZ*~QJncJy$_a5enB^142+U5ftpkgFG4e;#l# z$+3-FSu;Dg&8D!6A7-`FpV;}kN9yo1J#Ob;yEsQ>cd>`NjsEcFCHfmD*6Kf8@YO%P zfB9nVR~l*Fjqb!n8oACrWz`>zRAbgg--jZ`t>_KT&#I&`KyX6#n|5 zk)QsFVz6VsdM=$icN63(^PHLtraxyJ_b&P}Ln%im6{8cRULBom|E!atAGK1rOhYFM z*U}Ej@@89{Y-HYGyMgSXyv23CE!Lma8zDHTuM5N-Sq@zh?_2_CK|Q(-8-FZB$~9H?yZ|(BIhGk#1cj)E1#AdeXdsAjI08UZ)CAI&=U zoNjb0@@FHs|9!P$_o^|=TCo~)e$(-DCIkanlRw^q z8A@--LE5O%pf|IVxIfTvjRuL$wVY#f&mfZf&K+2zchkb3?DJpi=*?mMKJ+)Ur?}^w zpU6KS&|q~k^D~^ZDEP_zr{`Lv?&7`!T{?^3()s8|HnFZ2+f8H^`|9xiTO!6S=4&jq zn6q1h<=$F!jHBb=o(B2c*G`CM_62`F-eiRTaU<$=V!h{!5jDmeG1c=iirtO49B)J+ z>vcJ`+2_mWa?S=LwCuAzmcgD2*6d$QVf~{5dz6cf2x1*=2VZ}oG!svQjj%WH>xcCD zOy&M`O?ofFS>tywq3Lnf_?yzllf@d~HzTs!nK1vf34NC_0xSMD%iO^V)bCg<2W`vb zf!YFnR0>S)XO_(`6u9hffm@wf<{--{zxm~dtKw&x~(5pobW;Y{(jhchTg`l^g|BxB`e{J zZcCY|`-;3&7&E7jFrW5V6mHy)z%w1!`!10PxJRerzu_pyn)E{Mv$V*Gz>5g-R^+M1 zkss)Pii}m=DEO2ozqlY0lm3asqAkpouEqUW{@wi-5$L)(0&^QO-_VV2IX~uACq*Ee z`^B~fW(-#1*O3uez`9to8j2h9s1uErLhMq4UfrPE#}_ywwnC@`!pQ9%l@&^tbO%P!-A1% zSZ7W{gVAZo=u1v=3*Xm7zJMI$HnNUOwx%P1zi-4q*8Q7sKVnHbx(?38qyxFASwENg z>U74<$VCY2bQ_~`(RDAgr!#Z$;Rk(iabzRf=AzbD=1DckMN9VNE-21HR=+&#&ZAq1 z%;VTS^fCJ80x@|QSIX?$TDfREA`gR8n4xP&&ha~cS3EN(9P*H~joA%8%r)$g$MeqI z-SfF9&d!Bv7p2^Ebdc=lEoGG2Q9gS)%GtWD<@!rUY59*zdNgp5WG{Q^H_=|k|7$B# zD>#W?D`zFa95_v%uSS(~;B+=;iu_KBrZeqWg+ zy)Tn%+x+oQtRFtuli|%|E|-lzCLZ@CALWY*9zJ+;gr1bMe%R#8%=UG@$T~=0<0L;6 z@g8c%`=x4aAFMpZER;ijXwlgh5vhK>2mF`|;g2<7p663vRC1y>^{p>64|pH-^+6Y% zKl5bych#6Zy2l3}+WW)G&ktq1KevQMqO=Y3Bgq^F^e1P-n!yVl8RDw+SX3t4Q7IBF z^TJ`%i4LZB5%^g}?@n;>^G|4t+#W^vD~1@p~1&>yuh0%o!fhko(CdcA6=6@nkJtzX&2jQ5&pQ&K9R;m@U^TN7rw2c;sqe;TI#NX6lw^gd2bC##T-4fp6z(J&XD_ng@- z9i_)oVNPaGDetisM{{v3qFgW4anO+`Hp@ zC9mQ=7o3Y(3vzMkI{7Bva|x^RFuUi?i`80p(I2Wt48}EGU#C}?zVhrkh7Z%1UT9w| zJ@#f*GF+`TuE&*uUT$lKbTq846n(K{(UKl*QY#v2sM_d172k9_KBv?zvD#hz%2hk{ zTd&`|FsC58hi}gI9*^@P^n-Wr(|5SH|6*motcxx;OWdYTd*b%COsW6U@7jflE$bQ@ zc~moWm!WRWn{U=HZ=*Eas+uCYjq$R=I#E7lB+Ay=NpfROl9V?j%E_5pIrp93#q7S{Uzlzu!vn5$R_18%1NS!>Ws1tW)ZcYkI zkaQod)NQPhG1chk-mZ}YNeObtm-!FOrgoe_M$)8_c=pR|7^jiA2i%(?UlBT7g)(2I8%x4Ax^O3_mfQy99tcc`I`(R=afrR z9WgLdiGTl6qCqmf-Xm0a|CCv6-=f8?W&}U-^E^tmbo=%b>E}?klqQ=O(tXXir*Y6}f zQqJTZZiZm!cQsUgYWNJK3u6znr^D3f>q}1YF8}*26w`Wg&iI)eBVFD02Sedef%Czx zOoi57p6L#(1DZ!(>pFYa%eIJc|Bz0QO;TJ~bo<(5{ zLVCRC`n9$eO>{c!K1*MSk^cQ>iI`u=_1^^zCUDMp@wyhLJhe!_ZA3BmN9zO_aksY# z6W-CMm`w(edvSfw8u9uF-Q07H%p{<9n``}`d?O0#8gb8-Zbj~6Rv5)SRpzSQ-e$xb zGLU1Nk@q-igxQ6Ack_%`xP5p;kU(P#IIF}4G z;WWSgKYm8{*7PL3c9HsvouwIhhcVmROHcN|#ND!hnbg~XL{oq>UhZ}Fm>G8Q<#`(`b3nGv} zUd4YVdA(R>h2A9>H#Qvy$T{G7Iz3y=q$FQ3HkR{?{mfBrz#K^DFF2FVylMKaaI3W> zcC?cWR|m1QR7&+DO6kmVF|%GdbXaH!H%&Q=sHH$pIwSqg^LKN8XFu7W`{DjLm*b1Q zP5fZ}jBI=k^S2G*XvHz6wqqp5{fWd9KD!Inr^99(`#N5yq3(%GIP-$M0p~Tgc6sQO zl#4G7zu>$DeOLW*(YLcomRWX`bNco&(z>(!ZqQD;RPP{T_R`&S#uC>TlR3StfO}jy z1o1P>twTrT79Nk8{WcBB`_oT0vYRia4~c@q=_sVmqI;0@#)(Drf>$SVsZGWC8R@8z zNIyUV8H}#!h^$S_?oZ&^LW&M;jUMjzuwT-yvY)nM+exD5op=aA4B*0VMh*~WDR`rZ5ugDj;DJoMWJam z@`InrdKQp9-4KZb>GYu$@-zF9MmIn6UWcb6#qtt1JCm0WCvQrZR9?R?sGg9E-%Gz> z$8Z-}-?_cqOJ^pyvz^?o(?N`XJ2P9vl6eM}SU$;;S@LG-!hVmv{VieIIs)+r$%BBs zN}S)%cK_@?dlkSx!;7H}z7u59&nM-W`SeH0CKE*p?u(=oNlgQ7fOb z5+#!3RWEw3;wz{yV6qb~vo^5HN`;gqtPkWnVo4!6#&K%29M3)dL*(OTsu4IM6odGD zTuh5Hn; zjlnxvbBbj@u0BO(wMvrX*7P^MV=re?vaJ4*B6rE9?8{f7z?E#}da@xul(0-tp~tmQ z1XNqi-exsw^-?3-i5|kfJe~ns_=RZ^ypJB1&(eff$l=);F$T<}7yeuL|=$}j9-@Rl>8qUm6W^L4TN|wV5lO$o*QAy~c!oufH zz#1pa?L*FiUq}8@VR5n=?W=^MOQTTkgR;gkS&cM~YvVaa+z8fU>mLoyd}YQe8H@@? zS)fA%yEAUOz|KKfvSJ zJU|D#D>_W>qr=B(bfxVlPqdVLW8cT{wlksZ0~z@fk2&T)M&k0v$oubH)U$A(N*3hZ zS>~F?lOsG##__98{<(Hsnv>i4;jEK{{3O{KeUx4!6+Ro-2kWQAiO-ya3{oM;h3BVJ zD6Uo}2TKNapHYpC9K)-8QDXx?r-*g*Gv<;{xvF7ZihQhv4l8**dy5f|>zVMI+^64r zo~H>$_TMnSv`pdN;+MkxQxyyMtGg`RT~?D3ncyT%3!4eU)}_+;4iY@Mvjp(Zm&PdY z*=UJI6%^?3tW-uHDV4Dv7RY-t0w=Gs*KoN%x;OS`pAy}!<-v_IMvY) zK{I@Ct0H-7-zc==aqL`ArZJyAQ%mR|w2DG#ch2?uUBasfK6i$(@2O8ZOgrgnyv6nI zw;c37L3dFQ$JG_&<@D^~JEr8^l3wB7oh0>uQofJq$c#@H=}V@2{W1#->&!8Ax+PX^ zwtzmx0*74uaqJU&%A%Ob&9T1!NFLMX|HgdsajzobcR2#~C&Teq>quyH`3 zz1@j))uyDQ!tQjmT9JlXGuaPyJ{P{H^Du(z24}9_$Gy+PfjRAD`J>LVqI`RCWgV(! zlMYhphLe0Nv_Qnja`-TqPUvcUR=Zf@%u);7IOm7nb^Q>W?~8X&*b5rxi-{}zvFhJQ z^!-EMJ;(R&!z1BoABk#Nk>muJ!~HfD?{w)n6L$%RGwIiKWB#-Ue|J~*EZC5*teb}~ zTj-kqn1}DDT;zhUgM8ZHA`$28<=^{ubP=_c=-!s78exflmX?W*Ec~{oJXcqlLA}@) zJumZ|Oz^{e_Nnff$2II7e<(TMaA+Qd@|ICJaUlu^J~HcqYr};{(x4{;>z$pBa{PC| z>vVi&KKR9NdAMCE4>P;vL3JY!A2_BSXp)DcUtHzq)vnS;<08Z8%)ZvQGkYJM+lO;+ASu)$o5+j30U|RuFQKIuXC)gy@gGdg|rJfRlwyW6t9SR#h4+kZL;)|Xh zyNl%Y`26{LNrTGQIA+zqb2BuyBue zv~V94p>Y41NskSmg)=#pNqUM@+Mc)M`XaV6tSqRlj-M`c>h%e+g3`{2YUlj zxi)&G#Pss3ak5m6!)?hjZe_1P5_{vftMNDI{#I+~U2mhqRX5gm?X|4oks-Wd#FVin zJgfH@Kc~{|TjL46j&uz3S=gQXBposo?iN$Y;X7HluXVO?-|{O-#@y1#PWPi?`6*dW zFVadzL!De_esS{@XZ+?f@Zn-54qjGbt%ag9=*>z&2_^=fg9pTR!* zv0A(vuEp$R_SoyRII@g2=XNHv8E3+-2JA;75-rt;5>;T8v+>!$xZzre7t`$nky>*Dbn0BaU1D=Za_FMD53T z_TEVEmBPJcbNU7wS-8huRk+_G1K*^Zg}dfOqQu-wktKiVVV;*LzdP#0snsz_AL4|0 zwN=O)r^3WLTtn7%M$UC5a(<|hurw6y--lq5Qz&Z^YRnz|-+E7ndQ(}a=Q*l%TML)@ z{OpG7aK=d1bJSzh=X&UY?-P{DW1O$Waf8P(*3-hh&vH6F*{{%z=P7QE!aZy0F>&xu zk<;apWdPmF$L6y~@LRI@XjK^ZTZMN+x!xVCL~)W66gO0uo2F*}SSVcUgrdgnP>idl z#-tdIu>tH~`^hyQ+1xezxDP=`WA`8}`p1~?Ws(V-uCYJO?lEexcE5YbW4Qiz{nWN_ zKS{>&1dnGmujer4h5w&**uN>w<*!2pVn1g%>zVYRsZ(*g7P+nI)^e*6xg-~IRUgBk z%cQ4F$=+-4`qHn?PpK9@4DAPm zd?T4Twpa=p3`hFRaEu>mz|Ak&khM)EyB>Xu#q8y8!9KV(sVEF#9<&8>u|E}xCfyq~ zJekMZj`<_+v(fFol?-L>^Y40IsB<$6eFDh4k&E2%t(8Q5FOp-EhGXB>Fr?KZcbS)s zO@B9%6NW-5EE&{0ue66zF6;A*~qdvaS-QpsIs!+AhcQ4KDZkG3LDx9pyvAQ*r_dW8Z>yF{f5ZH;pV+J(pNk3-gCi0=QNZj9& zr)$T3huQ`#=I7FJWPKTOyF^Ztdwtm?9G|`#kn<%AwZ>UXOXeEe4Ddw?`OWb!4RGLj zuIy+pwcF>*+bB=;aSlUulK~msv$67IBk^Fq?a6YU=szS369=Xtyh;uQ#&6jX zOE2E)aEv9lHDFjauJ36fxKt=V?Yz*F*I{FRj+1yi>z7%}(>mn5%*-QZj`K@va%Y># zk#%S!!SsYy>gWSK_e#p`(_?o`7Ai2W*=}=@Pu^6fC@2c;stCHdBE4P{G4p|r>z zj(~nU(YSmnt{HRCrL2yOr_Z!isTU?6*@>G!=;d6`T;MM)rCDaaT=Aec^AWv`7Y*>g zn+^XhO{MTcf!z7m3l4GNa6V^XO*$KEbDPLpk9@h^$_KB1@;vI(zHVqLt+o}5U5qEH@i@;1rlNf><`kc6EKQsWrTtAW)MXuIN^@rM z(900psG&6ZQ!J68p0Hs3`1YbySj5w_nb%M{IhILsS08-i^*ri3pAQenOXf6|dyjsL zRdf1DJ;E_S=#Jo=%)!@Mg4X?!ZN0qU{grv>O7g|mvXR@xUV2y;$i1@R^jU}DuuUp% zYP0BbZY(XY7s=UnURbK-=e0?Xi7&ITfjPy&UH-_HRi0?_kk@mn0j1yuN(c02eT15sg^Wz zD3*X*p7=3<-hyogWX;Y(Zo4|tdRl>eF7igylW-g)|9jIt8`>|{GGNXhdA`dV19|^8 zqu26q3v!e_n~1mSk1U)%9K*B2V0>?Y_t9+ZbZsbw?+e5+dKl`A3WHTdDmwS0XLCg} znYyb`O7_#+=*|6t3e4$#n~h(c8cS-OBI&f4|6gTc7+O0O{#Ja>RI4YJ)`gPt$`_~J zhojyTa)RUmcXF?^#JflujPpX}Zea-JUfF2B98_|wFRyZoWCMBdasfNxFd-E+{>s7P zO7&z_UV-fQ9*%9~Pmid{P4}UHb6`F3qZe}bm|@t*>-Kdm-tXjRtDLPbb67Zk_s0v? z?{{KYq5;9_*%^99z!)1da=JW?0M34f)c6&rjzW^k!byW0_Aj z;zqU-OOFCM|IG^r$%79GVGdN=9Ncz}m5$_M+$>kYbR`jyu9=A6Xhw^_4@$*$wj3wv zFQdoseF5v6HOMFSjFIX49PnaW5Z2byVBR14-QJa9$If`k^RQ(WkQ%>|>1V7-Z`xyW zOo{YuwYJCjhe7D!L&wll@@4jB{Cs{;f^+N<8OyAny$J~B_ZJT#2iGlLzE0-x&luR^zMP6yhAxS!KkIqJV1}`UKa%cvir9Uw(M!LclA0-4P8}c>p z>19hZ<3jy-xzD`jYR>|>eoDkwzW>DUX1vLdmjm-{@&Ax^7G6>3Vf&uJT6gUh!6pYp z6kGJU$68w&ySqE6!R`VE1C|6sF>@LDw3qWw@_Tlo{ki4z~?M;EN=r^7TvqErVX-rJ0{2Dl!MTl zV`bVKdu&-vF3&)(nU-s~MhbOOw|!Fols!iKEkom9^d$DnLD+9{m;C##Bo8>c6M3i@ z9loB*M&8{rRM5mqt()ZalIXdsOg_Rc8wpm->28uBzkk_dxmO6LO{aftZ#MSUSE&2G zKPUy(_ITAf2=z0QpeAqVS6!hVKwshY(e^M8T!vHR>Ds+zAAeVR-y##`T$UX&9xub+ zV|0jFpN%(8WoXtpUebN+G3$OXd3YVF9VO5BnEuW7^ccQyU|lPWxet28yvc^um@+I$ z+AoJzIbjF6lJgt%n6f+@k;*bewoZ`igPc%ZyA1vEnX9{!{zqP)=Jn&G^xu}a!@Tcy z8<;D-IR|pI4DPk!Oz9L%_Fsp7OR|v^WkJmBJ(5<~0&i=DVEb#<0qk?Qr}~Y$ z^jGfc?|`sqa-d6eaM+py|I=mI`XoV~k+?i1g~4@5qvraCu&>Zu{lu&`8c4#j$oX=O}}9a=8Q&@ zGyNGWarO>~KgQ36_d}~2&Hp>UXX*Kf6{BY zV84{su*ces!I*tI2{St6U}ih!iPw&kzNPl?_6b4lx6Gs0-$l8RkL|N{=M3|BgcmvX~s`G4gt2PBRDDHV2pa`Sx*5kiKxhGiHr#`Kg25@*J#P$1}vE z2@<-_30KAkV_9>4AIE3o_Db@Yar7sSvBv`I5KIZwVcRb9cS#)gw#G>e`QN<$p*XgW z_gi23WXI6&nZf*S^004rg&?+wyrc&`mE`Y!(T|zG$euYr^laYJF$;_wcSae;rYA^g zO()!*K#rR}%AMKt&-z*Lcvyn8IOKqy{{$nl4*Afh*|?$M_px8RyxD7q;UPnF~+v=Pu?)PZ|@9+I;?KO*R_yI$S)qU#3LRBY7$WHA{J)JR%3}P=?$gd!l7~`Tb&T73c;U6N%-xa%B+cdp&Hf`N9&!jn$?%cXd z#xQ0lN;i2fs#7&R$W(B;MeRR4O_gV)CGUy! z)W+UVoAfO(J@cPGGrUjVKU1!Ut*1Qhnbvbby^NCMjnkJlYLhW3r9;L)4%IUj{%Fw6 zII%%S3)#?hSHCOijoBSf{O{_n*r8ToSQkF`l{0pCVzzWY7mVwv!kHwxcDk~*{lXd5J2}xY?t%fAnEx=H zeB=s8yoz>4hq25tEOy4p&0+X(nzsS%E->O4Q0qrvOj8bqcsTe>-YK1((DJ~bT6gEZ*7 zITU)<#*fTo4X2?7k9+eh{&E;Sw9KB^5sF(n4fI1a%sFHJL~YipYa5~IM*s0+J+85~ z9J7!4e(c*E&d2@wu?LsuRSowu7kU}_#kB^!U&RcKd3wy@xzU`PdQ5mj2H2VX059l( z{)_#(>`C1)lQoDz?2&E9dQG^V{Ffg4HX6~1^I)=x=k9d)yy5E~=6O$bvchWy^S!WU zvj1uxE|#Y&qaO31hv#C`G&A(9Rkw9ElgFb==QSC}?L6m5w(OMn@t z{-%R*Yc2{)bFsd&8I9iNB8UHds)!DUES?{o$icQu=1MDa;jg3Dhwh#1Xu60`neljH zE;ie+R{k$tKWACX;+nA$&-o8sY9;gTxJq(&l^odQCTV@i9eTUVOIKI1@8v8vqEu4p zva57>-bR$Qon=UpqclrzCij{;N+tG%H+|tQ*=ro6`m+|&a47Q|_?$k>kshyaB^?#6 zlEkb#yDrV-gV9dXA300A(QXnq-bG#qIf-wsi!8LXkc*32Nl5dSa{e~YU~4Mq-?K=w zNCiH_y#&f=Kn(U8DPw69YBA=M!gB&HDioX7+w$Tr*9{EB& zCIE5s{V^tRhpJPqFR)m;`x>#3jOQybq0_%aMYsGQ!-c8wNQT4qH$YhTR)CO*TYdzZf6a7 zJUvFuv(RHVxkc99qxaJ_;AVpTdh%4Gv*5>C#Vw6 z9N&_OH8;p7`t!f5)2p-4ghMTv^SG28SCR=&K4jw0H<>8&&&1~<`WV-;Hqtr^4>cyl z@^vqgeenC03F~hrOgdDEORbCGF{2RUbLiw*Uxf6Yto0`sVakC*6nPXP=QjV%x_|tp zLX25jg#GJ^@Ng`%5xAgR6Mc?5S)Yz8#P^eY&QE%zYSKwJ$xf8Rn@gR8Z6uHx(bK*;O58nn zxgXL>(p9ZwL{%3#Q>~>0@O!ZMLo3;HjIN-Q&1F05CW8k#iBo@Ok>#`zYezaEKDCl< z9~(=ZSe4{FQpudYtz-zZ;aAVJ<@e4(c4axs0l3PAJMPk=eKS!STS;DugY-M(C|9Q2 zlY_UDj#12RXO`j`I|VAQP~sSCRJRW+(9>IqRc;C_^(m8m-T3_)O&{uKdK?E?WboTE zxs|L$n+FO+t)ye>x)MpR6i9AZCMz5M7Arsc8^0@f#!1K0ae7eam5C#n<8>o`%UWyZ zrZp&&F$W|Jd$OK>V z#hX2>*|_>+&s$&ok?VsM<9w0Pi1jySxsR>jM^45Mmc_m}3qOtp{-|@&A78d>nI#kj zZKxKV&yd$8@4NMnDEvXrrB5d`gCyUZ{p9zm_+2cKheB&B^4=-dO?3M{V zv+3h_$uqMRtjk*QyLa7$>oIhb71QT9&jg2B?@?BPd2o^BRMr;YXc03l?vd*?7vd4W zI}%Coy$j7jr zd4v8eGQ}VI(67oftlF%ZZSW=+(}Nr`pS$Q{0sd%Gh(p^75i-3HA4%`kuTT2NX`MXXZj4F~Ze0G% zy{I4QKY!FuKT+4@`S#QPv~#)LGul*-Pv1PxJ-x>VH$MH+ntB;M zG*8lWWo2nIVs>^7ja}tgf1^3ASzza`4Hu-R%?a3>t{zlBGsGV170V~TF+Ez(aRt~)f2_(GW%V28s+rMWQm=g zBIUm8MeUa?hl1m!+p9#`O#r545TMeA2(4noS zi|IPoiaG34IYl>9P#A(;>F>5^P>JU~^@BAS$j8+WSkv>+;CzY(5xyF18_ilD|J(y( z7^ZpC?|p;$lze=%V;J;v=mb}3FeRLSW{C#a#x*DFU9(yD>c!rd^mn0%;kwb7WI)5= z20Flva37<`KfPHSByUriLMG9}02AGbed7(N%XQ=uHS3udm|<4Mh((jgov?oQZoQuF zSOXU4F`t?YQ7@j+=@%RD(8_=MJ8`oz_M0})pi!C`qK)l3)q`+%NJ#L>9(Fb6fPM7SVa~?*FlSRN28FoCmP#V zkR4||{VaKhU2@!76Ta}*Rrf3;#L$fx%Q5!PBFvpx zglUWE{flJ&)#pNlbA0R9+Ere5RY_D!dr?_bvhIZJnft};_OuuL{C zw1N+v$9w-CiqMbb>^BC$Ei?e-y!3k4hH)@FXMixd20EGNVghi1M?^h&vadae|BZ&1x;}t=;7012;); z>n0uQxJ#iZ(f*P}EFTqUmi}8}+!dI5murD^=7v`CL*Z4fXUXrhS;L-yL%t}C=5@&@ z-(VMwYc;ee?x@ACN96E3(D(H<3;nl{ci3!V-b5B!k}3T9qW}%Ja-7eggUrPDMg}8) zbrGs`bd$#RZRIa5*EJ>XQX#XAB(H5HFZi>2%~8PXDZQTKmDuB44pyQ-!>i0z?dFdr zpM0^kM<8o@WQmG>QBo}mmAS?p+mAWZoL}$y&=(o0MXfj!{JH+y*UE$r%gN#wWHBd_ z@25u*Z1ak+@J%6hkWX33dCO)mdrr!Ckg43aL>y@+3a{2OYEf&M)!aemS*$Sni4_hH zw1~@0CB{s&;vCF=s0qH9Rx1!oSNY@Us6f;?$lfBZ<7--xeWhn+<)7?*$kXE84J|&l zB5OJN97c_#ugy6NOJU;mrE_aH=TvuoJ{QTs+83egcdk?S7om}*05932sN86j4rlbz zps7*rc^Re62!rIl;g~#$+{Ivy-wrPLyMrqhZ*oO$C%O;!YG7VTR_~eyH*PTtVO%(J zZs@V%8Chzrk$E`G>YQwV`#1yax{!yfWk%8ix?hj5&yB9VmF4p=;{{p0L^6#j^fGD` z>h%klUEEZuzW1*|emqW=f5_EeT$ds#j}0>Syiw+>UGX<-`cI=&aIkU0^uexhGxI#* zY&c%;ryt2c7vfd&abDr@-WHDI)&{&i$~**Lx^GX=Jy@3<#%nSdwR0h@@({fwmuu`? zytrwGe-htgyh6Q^4B>I|db5@&)Tvv@V-(O+6p<|1t8`MxZ0Erhlck7#1HFf*h+{=p zsLAJtG*e+J*}-`RC!~>W{84#12F+z|aeXo%tHO}%%Ih;qgVr3ozgZjcme*zZSOcmp zW_IymBX-5HXE2%L;cPPwH0FMMEnTyuSU0eC7T;{28K9e@j)U z*O46@{ga;+^PUHh3>jW+LI%!Zj|cLDr_W6v}>LUaaOHx*qgnn z*3K|i)nLJ=FgW}syVEKh3pt1O{>J{$FU-ZPWWc$<$)WyZz@=M8^vE5KdQH7^a45FjgH7!&428CuwkUHnYLI^7HaA zqVYS6Cx^eCb0g=;0INJW%*@5$2h1?-qfi&}J&Yc&RD1PNs=qEG z+xWsklJ2=k*)tEh@PYfMbI!7NLMyqsNrBBvEwX5*57W8+bYpiLw@j_ANEZ1$9|qCWR%fWOBVi0RWgjxT6`X=g}l?EgyT`HP795T z3CB2JG;pmw#x1V4uz2XLX6x8e z4kq(i%=h&#-GkQ@SWV7+)KLXij{YSclgPgp(Gz*p2g&p=zpUhs=6iUy!S{ANBMP3} zBVFbBgKxMNy~;;pPHr^b-!|diMY4<|xz}jH-o*&=@8#*wy-wz1P$7DBDuUh4LUjIG zh#OVt^YwO;xB0E)LLZ(xy>OD4*>3Wl4$FU|c_wt8`^(DZFmSdK+8YYo%2S{R=ZHz( z{?Kauaqhb>>L8vAJUxy^g0J@Q-w|QRjR}Al?ZdnNF$8(T(?2WW4!tq4rV3UI#bEgPS;T;H zW6sDC`XaeE4LuNzFM2IrHPXUoC42RF&qU0~f&;J3kv>_7=UL7*NA4$wa6a$L^$xjw zciZ={_GiXLGp;)d^wM~cUb+rTmb|!R`9*hpHob_idA95^!3oO0nB&9m`H}UmxW=>N zmy0#XGlXLS$7i?E%;;4v$0^oWU+mGN{Cv(6K}PgDX22)1gkvJ<`#Wj=AEt577c=Hv zx6SQh6Br1F|?4W+uy? zb}qPAM}>A87qnl^^KM7-gPcFwP6(${T!T6nG}wMfgNYo2diLU3Gv|qedF1c8-fvJq zzxrGw3fj^!%=6gme&ngAu!o4_P6zgeFYA_v;#&&!xMYQTWqqaEhg|+hqe8ubu11@7 z$@0B{PPXZjW)a3v&?hapXG*!jp-d6<%B*}R4`v;A6Y7Wx-XeY6v(|z2;IvE z*pqcugXI&$nbBfI%Zqfov&KH&$%wtqMue6#qQNaCFqb**FM;5i;fFExmB9fOQzJwx})AeCCDN~aLcV>eaU{*)O{+%tyd zIb*q-6D~hyFWmVsCUVZ`Vnppk?u)pW z7`4TW)qTwPS<#FuOY?BJh-cXc73wQ=FSq-uP-l?E|G^%Cf5?08;J&!7q{^EEsWSDr zLF#`uicxKpL@PID1*;HRk8`^}dj+n#;M59dxPGFqz#N8sye>bggroI5UaJ5)`@7RG zFp{5FeKPs83~0mmc8q&Cs}M6n+2=LcHxHYV+0$=x4H+ z)H~>n9MG74>Y7L7-ySJ4gKp{<_YAVEhd~^UvX^9|3QM@pjph4VGR76j)5z$u_Aqx0 z9gS_nQEnYwqo=w5e8#=*O1d-;v0rTu``+&JTAkIS;spa1@n>g7(f`~f5BFcvt!c-- z+h?wU4znMC>z%50N;P=zRQbivj;!wg@{Biz)Rp4mVwu?A2WzH9Ag?=fPRS*yTpCN= zy+7o{8gCpw5s3nFI*J9%r7hn`@@oH(!v=4j{YT>bbu!#j^6`WDzb~`C%TYb^l7)JmWg%$;LF1 z{gaAi@IY^z7+WxhbVtOj)wfDwN@^MRV@;dwFqsg5H zvU6;)DDHcq6FJR7zR#VR%u)TPg|u}0DZ^X%AZ-Bm15ugqAdFG<$!_$QW-VHHk#&AbS1CCHXuh zcX_)+p3R}>@o@xd&CNtgy#n;EXCumz5}8}k8<9agdpwzeitF=%#x^pf_Ybk$@!?qt zy_}{D4CREKiF>Crbuy{gV%+Rb$ZxluAk!Z^ZaT!lPU!%*Ws1&TAVvki(xl$qQr2 z!`i;)&%N^wP50Q!qFKLWUa1deB}Jl`??31=dBZR}c}TzB^jkiNJIP#v!{lnoqbY`4 zOYG;b61UbHZKg#c_*f=xHY`A$qc-xHYY@j;zG#yi37@ibJgdy!>Ke8(bxf%YXa4fv zDH0Yz-?}%IOWEIL>R9GhFNws)D)d@bEI{=Q4J0+V z;KlI>e2UG$$f^bSGQn9MG8cFYbAE%gk#N1APLF>+(qSWGTNg{8j3H!0BN3v_K+~W3 zIDVk69J%&Qip<_*W&>5Z!7<_?jI9Q)}V&i=5GTR-TF z%wkTuE&`b$B8RO@2#7g%A7Bn16jd1DoEy!;1X+V!f6Z^-rmv>Wz2gVe`pB z-#d|y)1i$daNZ9Y_Ft|vum6~s4D{i+^z~?Cd3A>O=Yb)pus;%caT)k=;w`ogu$B2P zKV?I6Z#49afP1%0wEV=p_;(HIY5gVloqXs$jfC&AOf-sPX3+KqvcB&! zUw?Z_J{&f;l(_rFlK;{NgA*dLnH;MPYe*j_w-oI=j!TWn4;Dp`P2xHHD2|_2Hc~CN zL}q^D`;3U-oRxtW!}BqEwvE(nUM9oIGnQ3hU7~{t?b|XV%-2D_{>Lvr_lC(7iJUf> z*jlRq;R_l_kT?0$aPr7k$v^JT#4O%#-!|8hUX{Lz>W~j=b3AEOmVqx1^HIB+wWRPq z={bq>MOp-Q-(s$PdAbHBG?i*COC*NA(X>~QIIQB|_dETtXeo-sA9C@X4-~x52h7bt zr3~Jms+Q86j+k$Y$zA3~U@pf2W1j*z7bVCc=9$*W4u*OgeQJMYv)_lgx?Sisb8*De zJ;7+QREJw`wsh zEb!c#AcN_5J2aJkuA$^#_UE8hj6$vKx?g7bJ7C#1`Vi?29CtSd-Ye*Xi%F1Cp)GM} z^fEl@s>7?}IdEuJhFJ?^rF}TPW_BS+U(dX0U*?~VWPeKHehHZ6h)>x;STse4CE@f8 zRg>9JMgC`^mOAp!%5*bgQI8C7$P`9i(q@<6b#9#{m<`F-_rGzLXrF?phfJlN&1AN1tZL zAo%{FNBei#PzPFYa$}MVGuffSh!8YUk}I5_jgD?*nEd{LZ1%9n@S!1yNY=slF&jNx z6zcIO_e%xxiD$2p{pg~{Xn*DxIWbqdFhL%5cR+AN7)sxe<0Efqe9QN*PLM144rJ;> zu)&;!;R|!{p6_$i-gtTEX%G7}=5CX7T-`1Q`)e!Ifo_QsSY`+9giv~Sm{aVZgK^8s z&~`f68}4JqnL_buwjP7Wt z;Kc{z<3b1Y_X&bpOTS@M4g#8Tk5M~GY{og^@cB^8IzmrhbNT`Ed7b<2lPBvOu?@`a zO;19#V>~B$UxvD!m?!?3dDir4E*`?yX~X-3Je{E=PEL6`V%&}pblJ@J$(n+?J@4ld zdJ^B+WBct8I4N~dUC&091`74i6rBtlWsiQNgYoYt=5(iLw z@8t7c$rmrQps!bTCgS{ zLAEz?f|nu$Z$gsbv6Mc_Ze(dKa!-B;*`{XhCyCbWDq5qx)`#QN;K7m{wy@&gATjJj(%V1A0>g^xd=xj%CpkJKK zuIa?Q`4E&f(?NMK8!p!^n0G2x!d>ad^bSHd)^;Ax$;O0jWy~BqC@tW?wM{5CzhsVc zZ|2C;qk1~!fb_a;Pai-KYTae7eShBP{VlAM@jfAk+p$du{^H;3UAG+6_{Dti0Oq6* zc0kthAo#4%p|FfO>`5Fq?$9&4fd1BTp{U1kV--D;706fiTN5uUoE+%f2|=G8I(RMS zI1uw2clO4KO6!0j`e6KXhq>YBauCmPsm9CwlAFN4S1F#}@jp2X}Lvp_KW`0~43Ujdzjn|O-Uc%gY zMS|Qe;QdT~wgInyx&8F#`dIM0Z@esE_S~7vq4?gCq3nQa=Ur9S$a?s4@{`k?zCJk$C_q)(uOF(WiGJ;*jXt&w}vjN%W~Gs=DG zl-}7VFMWQmkS@88)fujFo@u*k%&C$z6#}wH>7vqZRDbkZ(pDSyOQsKE?+Eg=0y}BvV*~=iC z59*{*d-KgWSl~$u8B;Be*jvQ2>ohWs zD%P%@RIvAS!huOnIMtN(hj3yY2RVOrHUApRO zX9QMq!s6ZZFp`aIT$Sfhjhs>OxC)LBoY0y-|1;0<>l}54^%2%Mk~MhIJPcdn!*DlW zgI(uXL+}X0gko~=cf)XVDEIm98cg#DhlMrhkJIVj85D*|jy#XxIZ0M}IQo(?-t{yL z(X2@aH4jJcROU&448x8)>{I<$^FLYEC4)7%%GW4<5X$pL4gK62=8uwnoI`OGHdc0c2tcT6a#dxU4k|$&lL-eTCgzlUY1Cl@L@x{)74G;8aFiVf- zYkB6-l^NAHm^a;=e}0V~sd_y=@y~YA7|@cn=t?b^p~cq@;GgSNms!@|m}^m=85eww zR(F|EXhrAFEwlZ6qU>d2tn8=QNL7j?7g#WpX?w#_c}>=SCv%j*HnDw*~|B<4zkBnC2x5KeD^BrzM0NaCDKva z#yN;`K@*vG&q1EkQMWO~B11iuh)?C7MqMU;X%@+%GcMw|5`X?pf81sT5<)G^$7asq zlwUHkfDEG}S*kM@$r)#nY!BA3m$Iha&>~Y8{}#goB?1?-PRjbg`9BqKyQ9E7zGn9X zW)|2mQ}-Vw0xp$FBi5Ox4^|>=qD3C{v&amd*}s4HTZ$6=kd;T)u%AE9KO@6v znOoS?8(sSPA=t+kFYW1VVV$%6O<%a#(j$}ahp)d_51!%2d{+A7+6SPh2W!O<0SMva zn$ZC`U-dulqaUny_@f-py^E>^;PZX5Tf14~jtO9|? z4Kwz(MIzQG3NvP~Usc#w-!Tf6;&~SRlfC{M$w~dCh38EA%WUIy4Y%QF5=KkG}xzamW zL!QNagaORj;^U={qu|qB3x%(V8IsJtt!RQKG7I^;$VBI zOt`Ngi#3hUZNw}r9nYE4S>qT&Ch<5~DgJ)yITO|{Bct_$EWudQ|77X*SY*OVAD*MX zG9mm7GjVU25cxY3NApcU3VAHnC7Simg7OY|gI4G8lsr^ujY7oFFT`SX5yH;V30KN& z=y^q$6HBk#ghHGr2epIz;kcjzTzFA{0mBOE;wxfLC!aI25F=R6INzlZKO>n*{fy7? zC_-)v)}*EuLgPfPVoM>+jf=2|+`!@x=3`Z3jiKUu?p^u&WFO52vXBi6v1&eZ4evD- z_u0*)%GTym(a%om9+8YKf}^PH>b{^HkD9*;0;u zbde$9u2Rs%Nv<)gJ;T*OBKdn|vt4Bt=sSJHoc7}?iGR{ew(WJ1iBlcrK(4*CIjWL6 zYnT(i$X;fQag&DDPEsz@MLv#nla8!$+*FZU+*c;HzQ3i;kTMCnQYKY$e~WT*nGEZv zz_{2_iL#}8(VE%RpMFbEeyzaRpq-Pj+!v;GK^T^xMhn{>%Hm zoF7Wg1|XU>muW$K?1dj{#WM%<1|6qg>A867hY{y|a5&Wu{uh0*XN(_WulmE*#TN&< z`C=aHSNQ||(J$5)!-ITbe(H(O{2C_wYH7mek69ROVCM8-@2+itw7}9~0xrAo4rYZ(sp(x6@n7@10>oA-?kambkls zj%{+G`81xG$~kLH?vqsrxai29WGBq^a7NJ| zuF(GC9zEQdzB6WIat&v;a>mW=E>QTXVC?UNh*2t38cbHC^M5@ubT1Y=W1O1`oi37H z3{_zyof*}>sW5S~3XO)S5W=-(rL`)I=ejV%$r%9$op5&wp9fdW8>2$dzA(&Y9m!ESkF3Dix~Dvb|C*4tHG%=VR#b4T4RZZ zTp3xAQyP4(yBxi|$SRH`+qgI!9=pOYo&P`XWf-33YS4B$*M!x=@x?a`^BaUAZM_B~ z6Y2QoYn~||jxc{cV!zY3t)=T^Jw06}IvKhC3$mvNWgt1m^9J-xrSGgJdt!q1aQZ>! z(Nm9dMgx3V>+Cy+KJSBM8oBPP5u`_z0eaM-$0f$B!)?A+-$VljZ`Q*mG#M9a7?G$n zp!o@MA_ti{)L_*~>J$;GdHKJRQUGnR8P{zfjQ zcO#?Y%DUbLGaUWMHSICu*$QTuf_*iS%r@ova~Gepe~cN{HhDN%{C_-Sa6NZ9SJ+OD z?sb%{hg`)up|xxr>MmPW(z!cYiO1u}yT>W8b+#3zBr744hNAShFRmVCj|LgJayG)e(1e=qE+`kr~?(qR@`x`afk_M3Xn@7Mq2{XC{=N znT1tcn^-u0K9A?Pd9DC$^Na9h49BJph3GYfzDSOBPrEtGl$&HO%F#JK%SF_5SXP|p zEH!_Z%3t5fTioDWcZ=&(lM?f4vuCD^j_;#%Hof|<7selIGxI1N{88|?7T4C2YuAuV zX-Yn>ix!*CGY|4Gy}4v%hK$HU+-(!Kk&mm3EI8dR#MEI$SXHNxXS!VH6cpm~bY?zt zol*AERWg`+eZk-^vn#a~Yr8h08ES>kJ*;p(mwiFZ4*hsZfzqMmVqa$6t>Fcz(;CqhIWK zXh0T({|?~#TFLc!pH9*E!FBKZB=#KaVn0A$CZ@V(VKYC!biS7p-HLG8s|fdb@0_n# zga|vXAL*|<`-E=BQ^_)SwO%yilBH!>s*Lk>!RSI4#2!)M)<+i{+2M+yInJo$POt5U z5L^ilXQqh;sqZ+(#c1%?Y9lhM8}W*q!_B*Ttmc`N{;dIT$QHP@&O;3MfSwujHgU|T z(VYHQ*38F}El})GsGp2gsPCLmsQ1Mx)V15`WYM)lvZ1eDCern1=$0Zz_Gt!uR^eG= zSA2AKfytS<4uLMXu#5~wDfjU|=tv^-(EmEe*Q3l_xJ{mLqY;hP8ByyaJzM$oCS7Jm zLK(-%(Pm7a$Z@S1eX$O?h;2d!!@-Q?Va)uwLjH_w!BW;C_Ow>0oyqR0N7Fexn;DSX zlBGIXhjuFZB6+UjUZTR7udbM5-3n{S7W@epJ{hcS>#d98QD){l-JrMY4*h+e`PyiRUa38I?Nnw&aE?hsqlEJ3)=aH z<2T<^5SbJQGJ6N7)4x?a9OGk*aN%bae#C&683trFH#Q zcSaSS(FBz_<6bQN%bdgi%%7+v5O&9i6yI|cb7qob-!3^7Qbge~ZW;vOVLE)&p zT!SI}d@4*eB7T?=c_uvyLkv*e<~dD2Gfqw?mlDSJMFv0fxEakun6*l$=lfiRx_1CS zs|1Dm5qZn$%s729)?J)J+KS_J2dT5nLC%hMm;L_EQYYIA85RX}-0vi>BD>c>i2;8r z;dP6yT=>C;5%|&z(7BXjyYh{knam(53GgT$u4|EW(U-oivcpG`L+F2TE?Pb9p z1*$LQ{wj}qsPrA!y%;3}lD0S@LTf;dc-bq%E zZ7x;Rt>sd8W@lXSkfRlyvVS4~`**U}^JM`3 zJxmtA1N%4=wV3V8GlOngyzr-c`8>}G?s6YYHIV?vP;)Nm%^lvTm?Hnchpoc^xI?0Lv7oOQTOD{doePXQeVU|VAoG*Z_Py=7+k^18}1wefp!w=>4HZmt#@LQfRTWLNwe*^Q?mB z3f3LY;l&*jbIr+Ea?B2Op$B>@_b~b*R4XY&jSKA48qa-)m5W@v>?GeGvp;u>i!5N4 z!k0bva>-AD+=CX$oy%)dU5Pu76zI>nV?`roOI!TeTSA|fE&%WNd4=-aXWv~dzFcIE z=tSN_f$U}Trb}~nG-kD7Pv+7r6m;XBj@Rn6DvN#T=kR4~A^LMppJgn9rI5azeVpe9 z6=Cyp-aoxsi*1pcENbN{j$d0#Mzc1uCs2WIHRu<;!1J(A3ij_<;ow>&YFGurV^09` z&ifSCf+jOC&wX= z9-OacaD1L^#zLNJj@ZX~#Qj`U2v(@=H!9S2%y@qDf?hqPQmy0|Fs**FG_69%ajioV zxt)8mUF6|Q45Da5t~=WW4LA38eBiDLHBOqNF1cWqD>kUFJrHL zv>wri449?*kF7M|`A_EdROgr!$@5vB)n4VCQB;?i(f5Rf;rimLgU+jqzTnoLev4qMP8j0oloP9M>_>Q=*5?7xh;1PLv??EpAsTm&{Y1D`+H#GNMCS7`{hD3bClIaFOJNV4tamet z?v_C|y67alnUUE*Dj3eGurAdZcZWFR1K;0<$Ij@zn)Ph1fo?1c!+6dU{>#`OHz^$7 zv_=T`Uq867YFmqaWo?XD9L4uHAP-+&^SpeL8Rw^P4K%@w-(=v|a}Eu^tWdAuuLWe_ z@ALi%e@o``x>1I$N|sjpjMA{NUOF1-pGeosi&$n1e08RSN`>^Z-0MDb!4qbd|NDgV z=g@HWtMGFh%gpI!;TRhmjz_Eogg6_}!$ODuS3UZ$XN>D7|uTzT~5Yu{m?7f6IsSUU2Cd z38#om^jcT|Yq6D(v>)=GXJTGfk*Kyc1C6#8K%3S`UON4haY}DA4jz3{SKBx3q!V(3BgR+p`%#vJ<5*kAnN zQv?=gWnx=2eQJ*zNeHc(W3G7NSt^OE$P9!}E5PEiMsjVz52;5kW?xPOem%`Vh&dlS zeHzMBZLyrY<&7N)%ov))p7<8@2ClM}O5}qM9`Ql*a?F{v&BWMq?=ay~L%H3EdCKR8 zV8Mm$=w_b@ZMy>cBI?UK=JU>DZgLCfNYs7Bv*kt11)gssF`X@v$2?p=p8HLU%0O^p z0RnwnGLNl9?v3z1g$0s{ykdL5GFtC~QIaeY} zy8EK_@<{wFB_DT*dEYJ#}fu#*fbPNweNCsk2f}ukNbRxE&_)F1n+GoHUqxNot(k&+ZO@wbF5R8k9AQ^q)Go0 z>0L4ezTYCzfjrdGcl2OZYa!_KTMCwYV@bzIwC3maWkWvp9%&>`w|W-P{hyt&mf}IBa>O#2-uozo-^zr|Fn%t5TFCBQ z#jm@$dG(Ip*OG>A3t@(3yHCj*nKGjUpo{a-@lpEDETF;d7u2oZHL-O5B+!P*VPAKvgy+-VZV4%0qTEhAzO!) zNYyspIK=A~I3N?d#}x29%|@PVDV5926YtnK5<9cV^A4bo@?ljTi+u(rRU$t~zOwI*5((ql<`H?r)+aK^>oNbgUPC#U zS0YcDd%pi=1orcF6y#4Q@xC3|n5FZtgdtOwDj zd87_=aPHem^)Wvsfqu_tgCY@iAQJ=o6`<)t8~OTyx#Z;da&Iz^$SDI!-uY*f050k7LR^4&k4yn`ajR`iWa`hw3M5FdMb+!}?zl^j{`mf0w(WWnv- z^qOrTvv4v5d&m#o%E`g*z7{N6xlaQWfsGG}^G$pB&`%fIko?_)Z1`O+gGbd^ z3AA=X>by{VyT}}BazkdZ;O`pr8@_YIu1-OiQ24oH`CjUKRou7y81; z-&G)QIB0adbTv8R_Q6ne4<&awDjW85m~UI_fJ8+)p>B_0EJ&o6FoyYzH_Pys^?n(| z99YlWp{O!OhlF6B4ad-T_W7Ws(*IcN40Cn6=`nwP4zr4QoxdNHvs>*^@+cH_d+N|M zmAS6L798+Nl!?s6-qJ7_UX7Upz9t*flP!216DMOAIl$$wAmkm@AvZD`L1qgA&n8I! z$QI}p8ia$TN%%;P(qW$k+jQ|V^R6RGCWpW~jXYgw4%(9+95g;b=InC9!h{ga)9SF0 zzPU=|!mIN2YhK8iYG03KL4FOtj2||iDb=j2N1%qOvjPE`k83)sHH@m#k_C(>v#shI)JeZvlktaFXX(IDK)5YoP1W73`{2<+Pngo|ti`a+PtsTcTqD*GeYU5h^L$v+CuL*%Gbp~vvgr~n-B)FCS%1N->; z8+t^_1a~ED=?(OFq=kKP1}3JK!LmWDgpFr!@W1}pY^g&pJ@cA*e|9|^AunIkmp3N} z-}}?g_$M8k^rbMajh55jZD42-2)}hYboiT&SLF3doMPm1DRYf^AJ)64#l~0UdFzs2 zes@H=^k8yy@=Xbs-Tvq> zmR#gg^1r_1E~`h2`wjXEnUn5F9?-2beXJKsk$fORvMSkON7X<)TtF{j81KXR_4i<{B1Eut=FphwR#H2o4K6Pwtg(x4z%m(xPqiNBZk`I_0W za{h-B>(|n6_*;vWYtqRoaPM_GS}e9G5i*g^w-H(#-<5&&_Ixg`M#-sOHu!TQ5DR8$ zVfBkV^5imPrA5lX7q(bJZhAS#$?CD>C8v?I-V!O@S6BnP$u+l$gYhGC$)A3=H77an&V8p0-j#x7r^+7qI`# zG6PStOHrv?l>D7)4f9NY_|~N-?oI~!rj?>yS(IFyXNx2A12La0SD$g2*xa8v@_VAl z2-%`aXFuHKd~w2$oV9`Xl_^ThLT!=Q*dLv5X|ZMxpO-cY*G>H*<;WCUyjc~5_D6IW zbUp)PK9}O~r6aQ9kuBa|<@LYA@qb<>9`O7BfBlTrN5vZac6hlAe4To+WlrOim0PS_ zDp^%Dlud4DxTJn&*j_8t@J~^K!86S)W#9?5!6u=;VZaAna`_q6Qw~l)W=OiT*QNET zwB+F~!7hJ>3{2VFV}U{A8(`>o$C6_9R|fN#HHOur0=u1QT-#u?;iI8b{cSGGlc#hW znH-V4aI#rSIqTeHx0bzD-pdoj}Vh*la`(Mqd` z1gSGdD~5mLq;6DIS}^->j2))?+mR<>Cc-Ku_CL47hGuH0Ym-Ohb9rIC1CGv9!)Z0M0mUFYmCeW7H|aS-x81>wnwZzS>rfAU56l^onLFN$2zSZ&+~NXT%^O50eaj?)ZzY9p6$QZBR7f+ zvO$O2U)W>tnO}dW!#O8Ce(>zAWHNI=3i)@^nDbSQ%wuIeocS}GZPa0iFFia*=v}DA ztgq*MhQ}}i+ANb^EqZgl@oau3>lgN97R%^Re8f3%6&(?Ynb_x(g~#_ZG2eoI#(m6@ zCjabIF$;h5Goks*9t4iB^|R^nIhctq2|PFI&Y!iCtYag(6E0+8+44fbau-;6bqRd(XVx@WKPw$krxYccFoN~Ho@X>dm=H8u7!Vwp-_thW>2 zKx^rG%|@!Xv6UEi8yOJUN@~%0kXYSH2F`F2e|xpOCu_B-wT(PZw2?{fWFDop_y*Vs zPTI&@vXFgxIY`^=4l;IHTj_AnS|;vxka?A?q}SEPGP=A{npL)wu6@jKw}ei(m&HqE|x#dOXbuO)-;ZLp>9=A9C_%4jBK)02Rsp*;fb_l;h<4&E?~_lDgBFYL`^p0phqMIUBNbqo6+{;F9C_kF{| zU{Nj{&l`}bDj*9rkM&+}@=?#jkV~IUky|)Uke^Dw#9YOruPwq+cNgm=ufs6OijKO9%zEBU zZZX@4VPqTo1sdTvG!4@(Gw140Dh?ht!kwSTcQRrN&mJbfVqWe+BRn!wxvpZZg@2~K zNkvkADz;3cU$LW+Svy9gu?}405&6fSsd&oI7xH_0kiWV-mATX83VhZZG4ZMqUHG%d zaj&ErV#Kr^M%*YcLGd^j39Fb(dyS67`gs^M%!Eyq>2+G3i~cK3_~&dcuAVnxBLBPR z8~Q06O{kKRi{5K;v3PuF{Sxl~gr zaXJUF-`-lj)wY&Xu;4=48{NxvT24NM! ze%j_9*t&>5#_FDMzUs+*RQe!U6Kpca3v(NIAz0}}w~#02Dlfd6ABJt2VVD-qX9!_9 z)rI%{xiB0V9ELtK!{|x~$E!MF7|D93uXz~8@Oc`L!E@7bWOVwn)=55b%^5O_>HKpw zGox#UVb1}cyZt2dcsdMod-Iv(=ZC)YInLuV#P6NOpa0H<9!Cjdu1pxF^ds}b?;YMN z48Q(Og~bvh(to64g*`dLFnSvK95nDU;!>s&7n12+OrwjXl@Z0`jQF^lS#A%F_)-nbkaA7Eaa6z%?;a)+0_vY>1QE&l1FJQJg%Eijx}dG3>u$cIELHu^>P4XPaJT zor{w;Z{j6og;t{Cw32loK}w&qm!?ykjA^fx!mv2`Q9&oKV|7xUIcBPJTIv5=E7j<7 z{7rtbOFtEc3Hij`_NW~|_o9kkl570ssPMdmbtTp&tMygE>!Tf}m9xXIU#tzDCF97mo_k~Lp<$h{ zT`0MUnRc-JSA~FfDzq}QN7_*Kri5x>-kHut?!8LGG#CoHylZRFh3mhLJD3kTSp(Bz z4L18}u=aHj9U;L;W@{k8Lc(Fu-EqyfTXU{G%t{pR024THghrlX&)Xmi4(0taLw(Ia{ z20bHO|1~*44(JYDC^nTxLN$(w&Ww%a-I3F4xjv)Z5^#ctyC=rJCmP$ufwsE znTQ&gNk0@F+GHAA88dO~8GAwRX2O?y<1@*bs87!EJ9(0q-`Pu%Gx+q&E)j^G3y!-WVO?i;r9n-Q?Qh&TTT|zn1&?YU6 z{D_h3a?anI_;JdJfIH;3Sx0x{{5&R?V?rXwkEZmuhSJX(L;v5CwzBC@C%JE@mfVkO zIl1waFF?NW<(Ad~IY40yLcG-;s0Rdf=fm z-ASkOQ2wo>+)8zndea=`#TzR*VC^X5T06@38k|QPo1ynGb3AsTAG{JXJNfy=2i|C) z^TdLVzBpP$4~XME$-^WCI<_~% zt4K4PNi;_wuhHEKWKgqwFsqL@+LU;s(I6jGxkVT9dmnTsySQB&4$Ycy)Z+U#<1zig zd&2RabBsDR4F}H{@##q#E*Fyr$)uxk7Fot~CIlPk()9U{lOgwRBKN@S;~nTEC-*vv zswp|5%r+9dTq&LX%#dGThHY9iSnes6({oGZb+Q7Fv~(-4_rZIvn`e3WV84pJJcoR+ zy(kP5E^^*H%*@wMWGe%9V|kC=yq2kG>urSj^fVk`CuLzQ`(nnY!H@i4jcX=MviXdb zah$h!AN_2Xhf50_BsrnIoKI28DZRC{3u6z~YNhAp?O3`BO8Como zUi8N5U0&$;%L}%>z46h}7ppfj|9TeluJv3mlbQL=>vFNpZhSRxEx`Nd(IPTMyl-k& zNyFTxX=q9&q(MvaAM;FzcH;ZSHR9Qi%zz`~w5qjM;>f7ye2V8eU%WJbohUc_xYw_1 zkKT>daNE`vXUL@$)pvm65y#iaAk4o`H_?6#QaFaTAe+7V7=5<{QWr#N3z)0wk-?A$vmU!t8i75k+U+;LC8$Xw#5q9&N^mG z4^EUn%)GvOS1*<&dg(}>@VU7fsV3$t{#L`Cb^Hm|1Cdj~PYMjeZv+vjee>C=3c}5Kj z3p-q%9gIsOHMrI<7~`5~fRJE3?HP=%!u~^!>0L{7I60fy(>LPrp+y25yUy|qLkF$A zd`kb|7iMwW+XHhQFfWc7Im=WSZ?g(P9fPsQE*QUaH2>pi{8fRk@eRlQWz19V5|4EY z=^<<#kB#J2x|L-jm7L7RRK9QH=^`W7*nLSh{$Va=B(u2F`El;9!c}W$=9)f{yi6Q< zQ%Mx#Wxces(26Q0PM+`4$^*3;wVl|z(8C@UdO?MbIpKK;aGi?Uznk+qcb!i!84rZGPvF$)(KlfU4Z!aKUi`n6ZM zZo8mxy&0r%T|lnUjZB9BNS&lMq)R$VD-HU_%7<*NTp+(wy|O)alR53o*Y#qb8sp0B z;a05TH48$Q3*;#+gVD>#*TlJc*m?FVl<3j)dpy0XoQF-!$S~t|8Xu1Q5;iHAlgB=+i)G>!>BAa_4_eY?w_}zMrdJz*FP**NaErZupTaQM zCJduvxsP@aM+eSfOEespx3HIpYw%L;RaFDnclUsOK-nf_KF`J1PI;)DOxBy@&z=i; z2x!w;zRhSar^G>OzqXf7=jiL-)<(t-Fh{M}aK}%6AGi;9WNyL<<|*!@b7?jGxi#1i$lpJV<4`L1#R=OvHXcvI z@mD6i*qeu+?6oV)pktkVd@s%Na5BAvXts8d;6$}Fv9ysso^52%s4nvNz8QuU@Z6=d z8CJhkp!sWaJfzq6*EMg{4QAeS)CgQy;tP+8?Afg5i)Y{2=XEa}jg{f3{Vg23_}{Mw zaDKgFgtv|iet9yDZ7#w5Huov(>5P0xhkFKHh{5E$cjcktz&t$Y{uvKnw37v~ZKbMD z8>v3rNw&n;NyFI=@*~F#qxjKBYmOuCCE_|=fh+#zSQ^Xq#%;2vEq(E8yEnX3d{Aeb zFCH%nM|{OFJnkEgwY)}yj)r4#=iM0EpZ$@q)6k|-8uk^C&2P`SbSiV69ZXQ(GQrA7 zPoy0^gxq`VB4?>N(^h6rY%gD?sAZqEjWnvLmd!e~j6bS?AJ3vnBNf}Nev>Vpp(z3}M<_mubP751X@cqaFfobRjN49C%6Ba%JS(5W1~ zjGRk*^<~eeC;Jw@n=qB<3g2h2zmoGt@;DQ2)XGEc-OTR{S4xL_YDu1IBmcxXivLDy zS$mtWqn`rR+7`>m*St2NJnIS|r`yL9L#@0qsizmtk7a)V_q|@fy>Y`Y9G`oIW9o)5 zBqq?s>>G}2<#>Iz8L@)zSs%iK)#Du$b^5D<&lzW{`sKM8C_6c(; zESNLBBT*Kr;-zsMYfRVl;*zA3szG$aUts%v?cet>Idw-i0L)Q(5;adPkvGnvzqiP4#yD_&>PJ(q=)W$eeHziv2L zv^^OL*U8poz*zfwMgQOAUP;pKRia$t__LGa(6J^7GLHMGh&%R3kK~-u#R2|Z)R;_X zt&wNvLph%=U7^9l7OU{$G2M|5=xTgO=X+~r7W1{JPU*0}8C}N)J$g*xoEFZtH^=C9 zt1>ZRHaTjZ$5!BYophxPGi#Z-{v}J@gDkaz{JTRxGuK6r_4512F*!IrLH=2tAiFrH zPJWOeT@P~X%VOTqAo8A^*ISQPdwOcgU(VeWPE7@-MV6-@^fqtn5Kj+dLzgdr% ze9rA-^tfE8!{vMAJ=?LbeG4HS#;!BZk+<<+B+2<1u$fJe1t?EZIz#uLFDbpRtcWgZ)-PTx&$|n%vKV{z4YBUa~RZ z1f4b;%v@LIC|s{`E*rW;;abwo%yk{-^dHCdGNB4*u@ap$;JvdhS1-zH4%nEk#{I8! zE+17PaGe^i$5b%v2}1dp0K}AVFSkR3vK_%Ft+fh@S)8jL=`mqcJeK%yUVqAdvsQZ8 z7PBs`$i{{rS!n8>jXK`h$nKJbr)1x+^-#FhWr8th(6M?*fj(_r?P4AH=! zbJmTntQ!pGeZ+aI_z(L9#_18y9<}&goY(u&H>zUp^y(}O%g=%>=P&1JTm!`_TrZGg z^k(nGo`L_5XDoVbA?2?XihGG0o=y#A&MUoa4!LNhXHKhYvApWe^Sf2UR>)0da&|2o-{VUT_ z-BGSy7>CZ``QZ{N+2@AvHS`-sry}A|F7|wADh-%}ykzij=5B`I-dLWK z)nV?(+~(4~QK4*M{_MUVp{SBg4r?kopb0JH3H@UCo_Qj@To}YP6$`I0f9I^Nw5?qt zi61-=%QNpc3id!f&B4Tg#?q5Hzq#Mt@nd}`?yV>H_fIaWEpH^dW)zC^Sx-zO=UDum z9z$pL><+P#Jwl!_ZWx{N%(LFabL~&Lc&Kh6yUD?=ec+Cr+e2acz_R02<_@>0C&|N^ zRnyiJ{p$1F@JT8&nfdQ6YAW}){gI*qcf41GV%X9Y%xKQ@x(H7Ds z_>a_oG8}JxLa|Rz-&{C(LytysT3^U)ayNXL5sDz*Cr$Q~6Rh4$wucqS{Ok0`IfkHW zZVIXm$;G7U&BXG1p>&z#j<$v5?`9gH*hTN#h88j+k7@3wJz=aLO2;GfyF0Om*}jR) z*jXqkv)!W+@Z^jea)@+G&G9cw9u z@FF?2!yPaDLr{>Ag7d!2*FN4qU!`OGQal7jjhm{;Dku`obRCe)xOkv#8( zXx{&dT-MWCNQ=RLWnzLmKG!54w~z1FKip?8Z6u8w7Ko+79ZnzUhcHjY7xKSr_B9m; z+rRQ=zB}%{qIa);Dvs!K;M%;EG%qNS&J*3x@8K?3bWTN8r(C2AZZ3(YKavx0>Cqq#wBL&CEmrWR} zl>A|363BX$Q+aZBHI3NL=lXZBg`DeJD&NR0_P9#_X=na>o8{u>!UpmWJ&%j(df-fB z)`BiE4|;nJ?k=;I6D@zs`NM7~yA=Wtcjjx?&xLz&Gda)a!h4q|hI9$VqCu(1IQt1F zD_O`KQ;8g{Nk{e}@^rjU4%>09^0%3+C|4r8c>hX2-$(s68)m8(%hY#n_6DUzG?Jj#erl=Wfu2VZ~8YkCIre@oJGa-G{l z@GO&D_7V2g*JvT{?i9+rT5fbLhvL_vRQyA}yX0;wnNYJp8aDO7x|Z}^($n#FLN3f} zG?xi{e=W#gcR9gv=`;Dt=o~z~QCITY{S<99?>9vlj@L`Y)k*Z6@;ZmCE|7A6-EcQM z6h3?CfqnG}E1fMRmE&H+>Tb*&BL90X1%IC9F#o_>`V23YtdDNk&vDX$*KOzX9JKFb zDgUnjBg=+zJggatc?XzZPcFM?L}Rfz|3}6?cE{g2p?Ec({hYPwuc>NnTiIjlON;oG3pn`!s)SGnPZ{)U4MavU%K#vyq;q`sy?bgYp8>tji z93$oWaU1A7$kR0;Ulzdn^@K9!kVJ}iRcm~$%iP-!T0C4yA9NM^%QBOxH=^31Fhh2_=xa+5dtj}P77;~#T z(+4-g4vRNvu>XJ-PA4)@lbl*aNsK()Z-+|{{LrU5xkB=HT@IJwQRQfHZp^&t*Z@4} z!2bB^Qu0Q1dcWWR9ovH9I)Y(qQxkEu6b$U^qQ-7nO0cuagpOrUYO^ zJiU8Lu8muekJCrVpsM7mssw>X94sL>;5)Ju-SUr0V?8-aa(|b$@#lwTpsQ6GcH6|t zr7U_39r-$w$h&>dz_j8r9G*Z9Xqpns>Eo;4pS?T|JV!2NPVvhqX{A#_^Obzu6CI4R zGx5`oT+*OOX|q#_QA3z({6LHGkJ53MUQ53dk#gm}4Xix;k;VMqS0(8@*Dix;ZHz=% z+G70`Ke)Kkdw4t(c@@gI&xnw<%%QHAy%N*DYte2ExxZ>WSNNAanzIeY_V>rRtvYP0 zo{4z=dq0djC=cl$TyZrJjXLTu?PEILSLf>)A1M}rNYUAV@i?zGfMV6 zumNraK<>xldpW)@Gs!(|ij_31Kt4(X++Xp83=e(-W&pYSRA z_-qxf%g@9~g^M=0*_~dk-Q+QO|L8`Ot7;M@^Z9cUCk3JE4=u_nW+K+1434}$Q>!cC z=Me;7@@s=eWH5)K6yLHUq~a-h{pi=5xkig?^)m3yybMd8Mao25Iw4*L!r>3Sgyg^0 zhLRio94To-=+jIKz^IK{EI3F`)}Q=ruPAwT%m%d&25_CD#pLlBxZju0OO-fr@5Uak z$AK`Ci`@1*1G6Ga;oU4+I*<##*(DI3H?*i=&Fm(=&Ku;vek`|znz`*Q$?;7i*B0HW z45OMv2*qFMvBM9^=H&hw@qTDcZnRO9IMKV8Z03hvd@ih}X5iIig{!e@gp3-m#CK&N z*75o3?URWOyq-0`M99Jp^mxu@jV6Kl$h<$lsmsu9E&01!wy5kIfUa8RYp>0K|MfE5 zSsEqFQf)BePaq!f-`lm6{>pb{=wlxvyE@t75byuJ!{V^MN+y11l#=_1mBq|$A5n!l z$PKhG)+Tc^ikxXmlr-<6q|29Cuk*q+M@czn6=LQEp+^OtRkEHEL=N=9 zt7xe=L&?kt`u>LSdB4E?^dV(*AI8f2Li!@#1;M@#eTC+ks6_tPm~}+vGcP;hq(3Z` ztmm}K!0xJCzw4r;4xgiIo&6C$M~ACB(~*CkK312bGH|$xz10ECtI&Zj9+RBQ&^9|l zo{@hX@|K>^W;%F$BiBj)V5Ou8DQl}lT%qMp_ zJsqnTmtk#QtOOrcqF;O<`o_lLX$0R#Jw2ES{Qi9YoZkM}LVmVcwM=|^TZ)crV&$gM z27`A5qDw0sJZogaE}i~d=SVqp*ajy#9?qS}UdIf+PA^_JzoYWWgX7Fne=LjDqVptj zn)KUN`w=7ank(_GdjQN>!%HUj{d^gD+e`d8j!M)#;g1_paY*O$xMfr+4vdVDo2hm% zkP|;$M~m`h8Ns|@`T>Sa*+JvLgrQcx*0ExT59FaI%Zw>*NS(I zczL{DjS2QDW^>V#@L7dEj7kq4>BO52IA@;COME&+f_PDs*bC#wj~{ zc*LmDh4qXbAxc~wtH#;u{J!<9g|`hx8tWMQrUvp}4MG6x(phF2o+|`mJ?qL#9tNQ) z&+%(mFf%YggN(X?sI3pe;Fiq$Sf)YhG!5KrnGHprvHpCXb#Xmm`&)zJ0rdBD3Pf6c z=4;hsUHY^JA8V6YtU})o&!1*D(qP;mW`*n``#6Qab1u(+-Unfdj~)j(-_~oZN8uqI zb~RwuUj}oeyYt*7M~fAA*;8sFtJqhMF^%JhxbPTZfmPT0G|eFYC>WCLL=@o#|X47x{Id z9-*W47^Ka_E3&@LD`%n;>jR!HnaJ9ig`wUV@O0<-%ETgv-|dCw97fVGQf|sVX0w`{0R2ZeA!LXZ8KACzLr}bgX;f#b$bV$SZC)d1C2Fo->zt zA*;SOvXs8K$e*9z+6O}mJyE>L8y?p^ahl)T-~_oVdK(Xue=^_7n#G_nXjvz)>qA#u zd>DM4!=QAbXJ{S0iHCNh%FQs?WwSOPO80zl7@6N%h;T? z534dVRpb=M7KY&>&)Y984a2YpVQBd$41R0LJd&~6TA6uPbD0zQCluo*gyHiuo_~+0 z^RWl_N9R&8sHYJHi;W0+XT-G&Mp*A5lQ1fcwK>)=F4JAnnCIdbQ!)P+{fs=jar%}D zd^4iL6LJf$jj*|9#F*`@{raV%_DLhEgpg?*YsBwrM!b4sgza&<;^va!DoaKAW=2@K z@_gWn5z&Ek8nAZs;4WQs4bl+2+64b0CVcQPVdMcahZ{{$4>w^IS;Y-&Oh_7GLeZUE z%pnU^{w{ebPu90*<>GM-Iy2I9af)XbHLI9#P|g3x^Ll05Jk;EphkAc(`w zg1fU`Q&23W=4RL)#b@MtiS*I)xhg7_m6OV3Yr_(G;?1n~!DcwWhOWoPW+=_)9#_d) zVN@w|G!!W3&HOYzW4(AbGontJMD8z@+@@xjcc%4pXXJ~XpiOd zQiD9>$}mJ;r*~;aI70QIc)v0ft#7eb=M>H?4AwGBnblPx4EagnC}OQ_ZB#ghTn@wa z&pfBS5{8rHF19xd$If;1eg)Bi!P=*Fei*#Vk$oWl@Lw(I*GBqO=acKUr5o2-KoruqC{vW@llEOu8#DrlDOn6?vzGpsjdE59r@_UAFGGTlv&&Fnw1D;FY$V;Ac3^1Xs z56_k8unC|iwLPEDa9gs&=W@|&IDL*}9h(>C;*4b;5^I{^LQW>k(uAz?w+xZd&MsG) zr5fsM<{J7<6NB%Rk1h+oE-?%})w%oA^W$9FSU)$cO=)8oP%+3bzRD=Wf<20q$GfW~ zZ*@?lEV_8!;I#JT#o5gp8Z2+@>K?zjP4^8yBa?e)pEc~QY46fC+{tCdiyg@sN8^&c zzWW-MM{F_dn`+kMZJd+Kl};Cuk5(}zxBI@x#s1(ogZa;Nmm2PI;-b~bK)Ms{tjQ{V z(90&8OdKbS-ae=#@t`@d3&f);Hk##A3<u2Bm!;d7V%tADak?@bm=4cOCil673J;ofpxIIJIQUiMkYzMqMLftl!QPv$U& zXF44->2hFx8P9{dPS1pO7`@-e`1d~3+t0t-@(I1(i?ZOvn&iS{?iH}&E= zacm|I@oQ^rvXJ?K{cOLpup=iE4Wj-Z&shAzQ7&Gvm634{a+AKKezhEAZ**I6P?p2w zmnBl%m-9ugIjp0KMfchaF7Lh2jAL-icg&-7@-_S>rQVI8OC)wA6zT& zhRN0&%{-VDx*!Y+=Wv`So9?oo?BEdA_&?BrOYXw12K~1KFJT~GPkycuUFp?JUYdtq z9FKN2&V#pA9vaaf*)PLhUTEJ!pa{?kqlBs$0>M>`qX zw7ulerFm;dsnl{+;Po~-%Ck!3*~wDz$ne4tGhghai|p_oPxNl)je16Ja*N?e{tgOS1bsiGNnb6P3b=xcUsNCW88s{jNo7hRE{nqm3qLSGM4wA+ml0jUP9PUlNa$K48 z=9*_yWiy`HnBzKKRA##q{BtM{4^uqKA4PwyBa+osbKy{jgogNyr>t9 zg-z&YTpf(*-|H$1@ibk}oTzxzuq7YfjlF)S$rp^y!nktTJon9pfn!-S zjz?)^9_pN7Eq^i{hA+f+zn zujY(C4zMOmKZ^Xt89OyX$;GXhL)TW42Fm&DvE=yQM>r=K^zi2%{*qrjENkkqkbC<} zP06?lX^T;`J#r|a65!?p0(;p?z2RV5kce|UXsz{nZ~B=8f=@Y zL8MnO9$wYsR1W8Z{_$wAL63f%TYk`r(3EB*N2(+}w7DBWM`YI^26ktOUID-Cz(WaC$!4Y}Im-wkR^Xu`f!@-lU& zGIN#u;yu1c)#?Pp{sq~h+jJ$rXYFPaYaI1??r}CAe%08^xla#<1mJG||7Mk+c$|rf zcgW0_r(g3g=b{c~t_{bMOKGKWb(*4Z_0W+|(I{NY`6fyhGs2rp(8`-le6JeCOUt4p z39zS|aWmHsB|Mi}t479QHQL-(W7K%QKV(qbb3Px+dD`(t5H_}>f2&ZB7o3+z$Hn6f z=gG6R^{6$>}zj@>#3~@*LR!9gmhB4{#Umu zVZY?uO?EPFj=glA+eSJkwUsmT+R03wExf9vK&Rg381vU0eS4ZAwyPO_erC@T$Ky`i zPh6!Jv1)U=eV2H`(k&cWM>s!lOg1yny*`5bgGXWbm*er3!D)~|X&A(DxtpUAdtT7b zIx!C^+w;(jW8rghd)rgFR&Ha$_TC+2^y@aV=T>uhxWi6tBJAbTWP2(9UBPT)1%9k3 zl|x<1r27qiUfv8>`}x3das*P&dE+|I3NB}puXbdAz?V?O6^G-JuqWy~GaB?^ICg_v z!>lw^iXulHZ^WA$M%@0$J$6DGHgHY8xOyH|-lXTeCb_gOCS2hCN^BiP?o2}e1k7@jGOJVWPvzS)RPX6!*+!aQS+jcqv&c5uyu?@_v5 z7Ug0)_Yubqk*_@4MxHdVmu|kcQu?l?^j&Tzhq9d{g!8Dmrvf>?e`J$miG;T?gBACc zJ{{@h?@Om|yeF#j<3W-S>RtB1XwF+7gXm}Eyw!>C)3R60p@<;wsiYs0>x@QKFJX3F zBX+4Tp?ELdQ1!^?eK)~j56=V6ny}HF*XXecp@BA1%f?=!%Gt^H8%|P7=&l^fp2Fc~ zSa8Y=wS7ut)PPcHzeItl^LUoj$_wV)W7ZwxgL{#l*sz27+$yq!+z&c0-;MUw>4DA- zhkq1vGVH^#gX@i);5011%RV!!H1;X5pW>$xvGSSsBE4yxGj?cWv4#<6DbpRYhvusQah_QAkSV_Xw0;#z0*)-=pCPs3G*djOWxu**+jqs*PYa5dD6~$bKyd;2wm| zn*<+wbX~;0qJkidt{#lm!#VCWBL{YZZguty^^9TORNHv8JD_KMLPzc*9xaNQWpf}K ztBy0*<~=>NR_yOiVefXf!gbyyg=;lB{h_@R2Gev`^&YDBe4g8v*x_##)*an6h^V;= zjm$Neewuw-+{6+J193?i|TNUw$4jAPbGw zlaq@lYfk1|(?{WY;sf)+A~=tQ)BiU-LB1;Er6gV}-K)}{;G>g(?g^qGGq{4+=s_

n zGkHEeD+}FwWMRr}))K4Hhqx#UVxe%YJ&P{ig&dpLkSE}Ht-MKQ?@f}lwbF|@*Bra9 zu%Kg;6N-ayc4{!@R%2aYn1*}KU^w*&#*DLc zAT5bU);c8pW%=H!L(eQW7 z1DvgJ-MN7M9AoLNyqzc=R66N#nb}#~v)?9@zk99<@=}dk$5f~nsYH05JwofM@#GcP zJAtdvcY82$c<(2vnm}pmNE@XG0U|*{w)cJaIz_ z&$*tGhZ?+%XDUq_$crCE@@%0yzW)lPdz|M!>vEyF%G_$>FWI)&9YX_{Uy?xo;JF-l zS~L-lN_4E(_vHOc?<~)k0*-$~RYiSS`Jq6jSr3Qn#}K6TOGS~Iyv*KK(x-8WEIRH^ zCMFcF^aIY>k^|@2O~i}*QN`Jwh*7c!I3N|1M&{zLQ!|NqQY@Np?x?yU3}eX;9$1`% z?siRNO7#L!wPb#4PACSrkk|X~-}R!dTxPAnME_%&4SR~ar~D5O^|jDiJp28XGirW4 zf?mZf2CQwJgC6AR#`EY53uF71;&rT0jLhj?e3sW?Y6>nk%Ef9$ z3)U`5#DzTF_!lAQ*@L-5*?j%Xryeq(SQgji>+cncZ;w*(V`C2Hudon{_v9=8afh=v zJ(vab(EZLqs9QtX`jt80KRr<^oV=%`p!Mw>)ack$_E#yEZ2sQADxT%9O68vS6Etxx zrQ2U}i&N--Y{J*yirzh5x2GR1rKsW$xtZ^ddV~1$`M&s9WIyoBhVr&nf%vrc#JJ<3 znDr$UV_b9LJlaxjz9S(4nz*em44)>G^seVJ_nkA z8cJTLzf$ifbDZhlJW1YaOKL72*;~rWH>EOtfIDKE(VzGad!KveupUBxU$Z|lkgv0` zmbu=1zb4yr?%L8)HoW{RXO9g>$8Vt+wVn4BzwVoFA^KB=^2ON$H-)diMhYtNe)Ae* zDTi7VOHB)R%=HXGmr&*fd-C67)*YdE->n_shktP7P&dW|3H~cE_xn zp%@aJfV>)0#Zp&k(%$Hw6t_fA6wJa+K%vrwcsL z=0gZJKW3h9^&C`JSjpabMKW}l8$t>~@ZKkt^LP#vzLwHp+;7>imYEApm}$_7Yn=zV z*!Ivy*3$DhslXGBjUi~r=k9&^9OMVLmd{6ji`PLnY$y#yuoL-K2cGF(wvZC~6MyaJ zbCJZnqNfIU@5+Tmj-^!XS;+c?2NsMaha1Qo=Q#RO^IOQOM}H++;Q_nrA*h#QU}i}U zT3ED@Tir_KSF{J5bLnaIPQkp{IaoTnvD8f|lxBTB>GvjA`!fY$VL5PL-%`A#P@a-2 zT-BF3VTx4LJV~GF3M)~NUw$jYp~(!v*<&df_bCVdYg@>C@}d1}dtizUbE5y_D_7>i z^RA_gxbauYHRbaa6av3zDQMJz*V(&;Y)WK}gU`{nFaP;5Q*pCF4o(!-m$mJR1l=aQs@bGO2d3E|XT}`-_ZzXRJ7K$4=UuOxy$Q`MuF_c{MhWhfO_aB)R z;)y1yNLP}Hl+ObgDZ1TXY+)(u8{h&oEk9m37%cjMQmw2zTb)#+zqesSN+S`^I7fTghv+crf@dX5cDvjY(nqr*e4GfKnh z^?Mp2J9gW^da6HueWF{aDqTPi$lqBW5uXAZj!}V_xk!f}C3{o?Rml z-yGTF_&gok>EkP5e(r%`N{oK&kCh*_=-DA189T~wCL=~Vks~uq@rU`jI0Qv9=eMvF z#Y4&Ek$d{KGYEQT9V)cUz=(eI50VG;t8Is_T*rO*$-L<*^ayF`eftz90y$ zT=R}dNk_*9r5Mp8M&94I#gSHl*cHWG)J$@JZ_4QE)yey3N|?w=4Ve~)gv;ru$bZ*_ z7qQZJwGAA|8D;{IrGCGzMyyGRbGHaW*b_ezoT zEkca+omE-ok6LkB#Jx|)ejR;n1ESV+8kKZuuU;^}*tQhww?@c>7dD7o83;PU5i~jjWPAWzC-YD5kesjV{dH}m?ncGHI zWG#8dj}go|uth8Kwx-GC&gj!TVkpB;|0rp|`*XoPe;ggCLv&N-K$VtaR`VD+yuk+7 z_xqzLg3CXFhGumlWl0SsCff51D@=!>*O}A(xD?x*qh!6W5=BSp*E_65)%XmQ zye@@P|0s#zeKmFRz&#=-{FB<%MRT=j2k%I~pZ+=1LUP zOSpzV|4d#6e#Mod%0EZt!gV`DvYvB-yv@u|zVCmS8-65OlqdP`O$)?_b2?nAlz~Ur zOId3rhx^I~j>}o+IjTj6n;9r8DW!WVQlf*D80sE?={2-SanHcgUu8%n-*;N6#9VT_ zRaDI2`uq?T!{}k`6eaz)StE&l)z#DK<-C!Ok>%MhyE#Js1lwYi6&)G{T5Q@!p89DS zdRLB+1&(&8G4ubB_SSz53#G<5dCxi7^f6L+Ke&-7F;86~Rf6HnpZ_}Z z5cM`tU-ev^+*{#>sc)C#%PjKL1{01(Sn=|BtPrBcmJh+GF;#~?QM{g)t@v%nc`U{a zZg0sgHqm2B0PkZYeaU+!Nop-OJiopi(>oZ@X0QpDep;}gcD%f%E~?kn8 z;d0y=KPJdIdpC3$&;QF#hu}2oGsamlX>B4cu-%}kMgE%4d8fJLQY)|*KP*<(Xx;E` za|n)nPC=EW*|@sTiqGUm*9=!;@W$!BV%#SV8`*&}a{$fmp^qxC57(bjSe{S8(Pv;K04N1%C*5&-M;P&Ye-Rc-0 zo=x)dzIes>`mcPWN11g-eZQsWhumhp`U+!+Z=%FHB}>`2)YZ9jNbJtBpYW7HuthK5 zUM9=T**Y0BP$%OLB+0$wsS?JY*P!Rbj4~-=tV#{WLV8NEPTjMsPFjbiNJeeFxO^~3 z)>@rB*_SE@rt4*Vev()oCd>CZ2jwj53LPrD zBk3t?3!Fpue^TP)6Ez~rQ7eFq<9DqZ``6Gv8Y;9LMx93fZo*X7Aj+#?e?pD3TikKr zxe9~JdEh}aYCT4)(X&vET6_7rWDm@q%)jeRPr}h^B=>X2fCsFLzfxg7-}Ax?dRE8t z7z-Gy$WX3Phrc+nbuM)pUxs4;WDUB#=I=k#udurY6IU@d4`kklb8@X=1~j{=$Cea5`|PRpdyVTF z)|yvt&|{~L_2muJ0ANkJ_#^ci^?KH>b!bsY9Yz-eTE5XEi+Q6*jp$<$Wx%e1dZf28 zpu=v)fZsY8nYXCfm~3QSdKEg---55-#P=I;nw(=l15C&Dxap(E+p6?v+MSECoR5cg z&IV5$t)_8q?wt!O>nFi)v$5(kWB2}S6m6%Mpi>U&ouyQL3xuO-pM)sXe zn8V*<%_e(bLf1a@qJD2ex-DO`kTnO^iu}vuz+axn^=Kk^JLBr35=E zrMJRGwx=*RJj_YHH};SxUtMKlO;=H;c}RmV)O}o4BHyc9C3pe7-k$RF^b)E5-Xf>S zF8&)&pXfw-^~G7GQY#B}>TGf5w*pSvEHZYzRc^K`k$-9_kSPkpvPbRdmQwCNOXbFE zGLSVCctXv&i5;l>*i?ac)5td-P~d278@!}e+`bs*A`TTxC~KIt-t&DbD6nNw>UKb zD+7Y?&j9Wrz3EfkfqFd5Uvzp$T{!nZq&E)4=eyK;Eb@nIN7k~}1)-$G9~Za>YelAO zse&wITQZP?Sj&CshmBRZmzxxgp53*Ww3Ruiuk7_dOE27S++UZWMjSb)v1Au_e2<3x z3~~ehT5RR(C*RUyrG>qc>8wk04?Vm!wHxiVD9q4e{7W*8b}{S?qEBvJ>OKZ)IbSdz zz}(SUel)4c_u_FL#k1F}Ewz;Rx-;{%$mQPU{v9p;zDW&%Et&LJ$;9#6WUXx2(_f9; z)bmUv?a##34H-z?n293th!dErKfFB?wbH0B=a7ZjQ!=pWIrA?G8Thy<6N`|Am?l}U z9AW*XkbR4q40yO@;_=l?jC)LO@>)84;xaI6J@<~xv#)X?LphtCxdr5}W{|tmlFxcw zfN!O&)!fU6MX1a8#EfGzsFheu-MC=tE({&( zsh{O4aT{D^(snoT=Qt_zkF#VCZ!Ej)n@Z_G8D`r|PN_Lwb~%e~ zcT@4sah2ZGeoR+2l_$-ciS?&iA`iHU`fw9j7~EXSUviUP0ge*#i{53&$P(VNNQ8Z< zXm*hsj<(8;0;^o^bqnJi5q`Qspe6uME@t}7rfE3WjG??S$J2f6_ zkSXT4nZt3leS8e26w@yvA_iG&$w55VV$6At$A>Z4!S`?QG79VOYcb_hCejB}LvcYS z_KnEI?r`P@M`hp*$C0@WJ;5|&dL76ruFu546J!w+GWi~v$owM{FN?@B-eX_Kt&q#bH-+xTjjUE1#fuZ_bGo71k?nT^iRb{peIl`|fGJJPuN z$Z6y9>3+u1)~Uwwvo*%n^nJ{@s+UVklBD13BpLjXd6(y@lERwNoSyVMqZjla7M-}z z3)0>vRm!lZIT<^mEP!N%RI(_^eRN-*B-z(g@a8^wLAn~hhN&>T zhZ436$P##YV3(g7QHSZ@HPHiyQk1A)q{hHj?oh-kabUCxS8LMOp$2jJnnfyzN27W`suqrDIci)G>U8}*g&l+@m5Q-@q!r&YcjFJXnsLMUz za6hs!Ey8e{Ye9#iFl?B?bz)7{_=ai_RE4@^ed&L8APm35LScJV1LIw4K2{A!%EmBi zvhg*eG>GAvF+;REd1;rdV+O>QxRx-CDb+o+&!3fGdakLmHA zYs_pL15`5%h3mOn{{2eocC<@nUcdl(t;gQ&28{VL7cE%#%ZJ=?0NR*t*0;D@NC$4(m#|u_&Y{=@3 zU&?tdEEC^3=O|myBbf8aIgb0$t_7I&fc*+zsORDDCKac&6VGt9ge#pSc#cx;d9;(w zR_X}nvj3%~4MtwKLEcJRZ2Hp%wWbFEr2!bZkRF*@_M9Y=p}!h{FRfzGqLk~Lr&@SV zAb&oS^YKe99;_rA$6krf%d+r&Dz%D6(?575nYm%~PbLrd#zZ~DhyvJU+0{|dwtzW?mKfq2(4 z5aE908#@Kz6Jy6muB&>GXH4X|O=4W>8L7q7h)g`S<@|d;6RS998-{0Lm}?eJJt)AC zS_K$?H=ml-`FPFi^k`Z>4mh@wP4wSB749MTB3j9jrfntRw}*6_VS`kq0yg_f#R>(c zKC;E;400-DQJ%i%dUYXvGWj`btv|l|(|7tL**rUHdGDbvnU(izGyTEmZpYC>nYjH| zCh8P1R=mt)-Z={%)9F85A)lIioXfeUDrSF&W6O`w)cc6aL2YDg*Ov0dNi6|Qo6Fc; zt>yZ%Hd3Xr4L&_kAcy@&OMI*n-Om<^wmdJ!_BM^!H#CL44Qc!wOHWg-m8%zP*?Z1w z!)r9TTnt7I)WT&Ic|xuq6?uGKBD3g|K_BiM^8CDaja+zbHs>R74L!lR4m?X%ej{1S zm*zGyA+MzjrVjnA&=xY}aWgroQ&BJ5B26YKkTyVpB?GB5`r9Io3%G|ENLGd%$ow+? z2n_SX<=5mH#|Pp0`0WT!XAc6OnH?j!7WZfG13#YFUO)@-lrD~37f&S9NLEIv&O%ak zYP2;kfMq-x&lP0z9mrQYP%ko;EJ1jxoSsaNPHG|gh0)u2?lJa3Qk$`p2U@>SqBXg% zY)=mqy(5d!N&|b&pPx?Am#7x?iI#8=+-L>T#--9fnDz4l17?RCkb9GCb`Jwy^q`kK zKPvv4gL~XJ#$C+Df!FlNTuKgPm%{rCIfs4JN_u;UT7+8_-Y0i67jZsSZvUeb@3VS2 z_3WVR*>^~uT;qPfSdF?Z+z}X{hG%)Qd*7*xm`>)Ld;jZg*n5~4#{4w*^M&la4o`)u zssS+{=q>V#+;-hm_BfLRFU&!o0&>;obAYzF__QGVe|)fYJeQ&m3hxr?NS&Lg@NTkP z;qAq*2RWw5>0SmINS)#pJM~g4kY3NldPyp)hG~&IBFef$|I!`Ho~dDJ;!gi=4c2Fb zQPYc>zYD{0pmjKoz6{4c&eM)tsfXxK#&aX}BKxGG?>*`@j>zR&lf8e-*iYCu8^5-m`tz!sx$FR%V+90Vl#y!^MCp%p@sRV z)1&juSe<;ioGKx+4D$3S*%)4*smImm-i7f#RSgIFZcOV)E``@~LO>5h3i){FmJ6WdpQ~k1ei|4LQR8^BeSZsl=YijyyNUC>JuQl^^h2A{E~2LKWW6 z$(bBR*xGyQPp<)X-l~7~rfErzQtMN9_9e(ZI z(T>`g_w@96T`5VrA~3%b4jq z@Hijic^#ch8D25FH|k+V;=JRfm%-I zwv>5f_I$=s$2X39*lM(V;Pu<4CWF#)Gfe{qq<@tnps!pZScE3eFJT8%yEfv`Kf<1VB z1M$3+x?dv$kbln)^~U-mhS$TNd6aDjxwrEqXBowwwJS03Db7M-qb$TP&qBXWS$H`& z6T`n`A+s5C6HB=ls>i;7G&9Ct=RM=~XHp9JGhaonWdJyFI^;HTU${av`Vop z*EaUYB;Wskyv|HTfS}B>WYF za&O6iKFosGs4U#&wJ{!NO#POLwd`+;OQ0Wj1IG8s1yH=nM_+e7KeY=G>6(t|N8{=c57WagTCk!|$n{5Zw~=gGfMYplVFFvc#=aQ4BFM|(z{ zSgx_{d{epKpdR{8#*Mq=;ZIY~w|*|YOmombg}Kt3AkC?V&>$^E)OFQ3 z!hHMe2JY-*q9%aS9p~%O-+3qJLSCO+oC}+lq384i_UBIs$J_nvPw?P87(fmA`_x1v z8`rKE`==@}enrvi$3U%ivT>_B^IQgVp58$1LDs7~{A)!=#`td@3hyK`guj;@7F}6` zlDuDR+ARu@`LzeXq@GtTZ);YKIz$c^ZTbWbDe;;H*M}6z;G3 z-VMiyd_5)xGnUq)huU`o#6rJDmEAP08$$ z(Yw^$#=Guz#*OFf5xA<8<~33!im@Vks6iUkJtFJL5N=QKz?d=gms-bKrkgw3-Xxo! zLcQT24aUW5$Vh0=vJT@!9}O;6T7lnV*{{GD@n|piYVWCAFphh#1A0`8%0_7oJ~wHM z?_cRzUM?3U19I^05#z&gg}28fY8~_XBnI=mhA6xbBvPA^UW=^7NqnJBy00K>X-yKt z6c2oE<&LKbZfJ6sIy?XHyjHlw=}0)bt_Vd$oe;P)mfda5emxcaxswc-c-w%%^;6OB zu^yFQkg;e;F7|N_e(^p%9hig3tr)x3(NBqAHzmWkpj6@QK(6skW9mhc&2`~D{69Qn z=*ng?kU8-X=OLKQUiGEf8D!neNUiH6^IHFuFehK^TcX9qhMdp(nW>3wC*}Vtk&on1 z&XVtYH9P~cZOoYJYcJN*?Dry%_Gt@`3$`Ll1KKkp8WRsEkW)0dZiZDmYKNYp2u866VZ;ah{5cK z(a!XHeVvZ}qw`R%hO>C)TI8>@{^&cDI(H4pOOijb-fbu~SW9Se%pcmx+>hpH9x zO%iyziY8b-Vj9YVD5erbpw0S-}ZWaS-3%gwq4nCy^X%lm($_9 zClAU4_2txC>RNUVKzElYg#S#(?Y((8KeMrP$h62x`u5IT9gRCH(y_gP8K3SqmQzw9 zOGf*lM+*7M`5E|U1ohFTHIktGaJnDITgvCP>^9<7lt@_ApLkcZkbjQP4ZZnEJq z`O`PlPrOe4%RU2xEqtzKHNTJ-(`k@T(%is$1 zJ*Q^DWbb+svaeV!clE&rj-&gTtU+uxqkm!paXwxm4XIZ+w=d7XX9gM%CI9%czL+K! zOVJ!Z?CTzd%X>31HkH0IzntV);16ltoOzCHjz>PvqiUHE_pGj5D9e1vSwDKIMPp0l zbc9zlW5tZd(s*W(WRR<^QxFY#nSp-g%~;#IzLblgkI^$;pX4ZXo{@p)4f8NVI@am-&#NZP-|J|CY*w1_5a5K;DhdbEkD?*z{;5ftkOgTXpsTHlUvZ zbwxJ@=b_31J1K2$5l=I9E!R@N(j|l3B>llBG?XXpev6WNroFSGa4azct9gB{pQt0< zsi#?+b*G3(a+IFwh+N8^^b1YoN?x)2{h2zLypO9Erc;C3jPi9HGbUE3Ef?sQozyJ=2YYCd{UHPOIgW0(Y9OKAe#vw4uo>i4 z!-MEcUdN1+q4olLww34jE!Qg=zIW+UA8AHOe-}CIPCZciK2M2{#`!-okg=Vda-_S& znu}$6Q~IHwj)Fbsjrbnq1SgUYeepxiQzvvJdBEsu8EC@sa;|v;8Rhhw8bjn3Ymwt? zkbxUq=ika{CL@Zdqf#;mR8L2wA``x~&Dg;F!X*1&lI2fb-9ynh@GS#3znQU1 z^e*H4u;{L{L}vYz#*Vzsm9@BikUa83>WxyX=HjYi8OV9*ts`rCJ{h>>M6Hi4&7|`F zQaL+~zTvi7gimIUUrkS>9u3$>|67{H_;Kw(-ILr5G;7c6On-Un#X?!g>)E=37I!={ zF#2EKUp|K&vWlecRA0oAKkXBdjy%SleoyS>o7y7%!l^S`KN_z8@Hwwwre#5#+?q?h zHs4Uh)zaZBgCzDH=)dH>LC^03nJA%CoN@FAU%yv}ZaqwB*x7=(Hpw!4j*_*FP)ztp{%EQRn|@GV zY-)-qn1iq0J`9t|6KzXpOGL*WXz@ucN8AIGO7=?>MPVzwE@()CUZuU-NKscFo9V^+=NB4Q?2f6O7}D zDJYC){+WKn_PL4DQ>DVQsml@S$Ll#h8~fR_5gnBzZ+5D&n7+mb(}f*zv-V#-YWELqAWh<3hlok=vhME^NoTM&ZzifK!Sh(km7mb>FVC91G@q-?@ z8%^jqkZbOL$!#@u!=|cX7&e=0;(^)Bp;$5fX1v@^QQ^i^`b7Ka;ltzjHll9hz(iTM zpT5tIp@2b$kIdVeY(SGn)VJb#drHSdNo?qb`}AQqmC>U!YY5kVSs;yLrRyG7 zOs1aQeEz?+@6j)qJZ82gR)%#~;@uYdT{WVL;%_G<5 zMb2>|byT~%;dS$1Y195GAJ63qhTaDY&|r9A8bYYum)jfok-J zJraU}CUS6mo^`xm$qf%kF2}p=vHzd@d-vRgUqM#1X^|*SRp}SoHw@{csW18DA*?A@ zR8hrBr&J|coejhCw>o^{IBmJWidW7_GWQ=PhF=Py=C&T@3fZ`~+Cp8IWEtC!{Oo}c z^xsOo)Z_p8cT>l3eTwL3F(1X}E&mn$;(7duE>^@3N|vdqDtP`3!MW!;_NqU`sJY~+ zhf!aZI}u&^(k{b~?qHM@$${S4FIIA<%9Ww0?#sPf&uk3%%ZkStvGQD_gpTj~xCiH}&eSdSR(St>Oy6*m zD+s--2U=5!9(lo-PHuXup9x(iQm1k~YpO!M+MVRn z1~4ZZ$NLiYzvmgfpMNrL_j+aA(xid$;)X*;`~0QpTPklfrnK&4v>sjPHSqgnujqR3 z(`xmMGHyQD`+TPMTh{~kY}0rAT;b&q)-^q=dZgF*+SR(PF1(O7`|TR97JD9^-~Kwz z_+84UcZ?kEnRju@xzmorjMJ{&cy|(YP*IUfs}1wSDXtRB0F4CC6fM9ld0iTXIqN=Ye?9R|jpZZDic{7>x8Y=XMJMtT=F;S()pA+1v&!R%l zu1bW=Qo+2(1C`IH;q{2UgrbJ3whBke@wJE956Yg|er>6_7_G$ldCV_s)wo`u#+(fv z2(-=R4`iY-dXD&zmgNdv`^Lg*Hg6u8h+|fejhQ4z? zX~UX=nRV<{%%QO#_kMlWh8i&LB+-xXy#f8Y>JjKk-Q`bu6f^IiGs%FRzRW58mv{R{ zUoYk=R1OBbWZtR#F6v{b4anMJ!1#8|v8<+MBjZ|YSMrL3vayHxuQcYM{_}%gI6Iqt zoY~N}XDua*dKJvyjc1Le_&z-XnYXX@lOL=<(Z~yxTI66zUN&Z)&qbe3IdIxfZJv6p zS>MP;w-xjn;qQZ%WaF@bV_ZpJuPo-Z&Ss-s1ih?lXXDd1YC_h`##`q9H$<~)5XYtsdDZ7`5^#&;eH)Nm-4;2Jil zbe45c_V2BjVUbQZ*&ljSfx~5}%lP59oY_($lV>O(^!9T-z`SmdMXr)%Y_y1dYr_<{ z5kbF##jl&PO1Vh zb(OwE96{&3qCgo*tF z&?Ag`3VDH;Z6aIsiM|&*0??f7qeB~dGJYd#wIT@1+6Uludp`u-^TUp1{F?QY2x`;a zOz_9BO92?MpZakPVvyg4bzScB@A$KZ@rL=IWz=GvK|RH;)c5Jm9Qh-9@~zWi3BRA4 z$lN(|HRZNzQRxGDstheO{m4E}rMK-OE$oIf&rjXPkhAoPTEN=%T-MW%#=zNuT6D~B z&y9>huU*`OU7$`7Yb8AzX;GE0FP$92eJ1PL-_sFQl#T=MGw_2s@Pb{L_{Ca9UIH~4 zf--U4jowl-+2`*zKXQs~voNG- zCTf3X9xRieJ7=Otau)u&nu%F|@_78)Xy#~cGS5-Gl`NNuc?9M{@;m3l>AV?V&3U-p zj$XFW%(wGrp@YdLE~KwCbMb9Xu)gh@j{%?ZQTGa2EAH<`oT3-*X)=pP^YPQ0?3C$0 z?VJLbSpS*xFLmU~uohK5AHHpw$DhaF8O^9rjsAtVskd>3tQPmm<9D%Eb(1+DuY6n| zN8N(&Ja%_?@w!Tnvk;Yh+u$yVyOmOAT{8*2kEk|D{MRUBF)F^hA5p`OL$7iKnB6D1nVHL2?ZZY}aGUKdr_FIVzVgL4r z`X!Ro(klPyNewI{KU_(HFMY_U6qQQTP>Zx%sKCG|tN0u*mYm@wa%&8A8r#@1PS~IU zeYQfHvc}X-f$Tl(RlUSxHL}vD&?2wsEwja4!FisZF7&<0JY|)BbrjH8O2w9a+S^L} zFeNDv+8Cje(00&wLewI_T7&@R>&3-|fKtpj~4n{r%b4aL5vfp}rVx**3`(4+ut z`^GW2d?;qDBcHs&AHi1wF!&zpl&iIfjflqepcptg#^4*Dd(S@n`OYYe*&mI9`qV|e zrA1{GYls{>mF;3su}TbT-HL|(0lj-VXpvG7jhsR)R=3uoadI^5m}A~{UW*SGSzr6_ zSY&!?TxR}sx)vwHwMZ_Z=gfE305!}-e~LyC$L~4jdA8Qi#OfpTue-_q$&p!DT8$ct zCo^IBL|+r;+SbfU$1~O{>-8b`dz;Kne~vfuiu!@%fjIsg%2U_Wl`IVNMeQ@P(7>0q zJJvW)aXi%-N9LGg=K*uUJ!g_>;0 zT~*eFS2Qj_MUF2Ef4``XV_Ne{8@+Tp{!Y7NevxL=+C5#bXrI=v)c^ck^zyn9QODTt z(_dbZlVa0uoVHJ2)P9H2b?{?P)qsg!?$eUfew1`E#;+V;9Q`TWsO@^excAmHuX(L2 zrANE2H~usIUDt5kGUH`kZ=>O5<8+t#{~GfzWf-Hw4|-aL+NSUQbD!tf$UoB!&B~=m zS<9!#Xnq)%rO;oxfkFQLN?q+rsnVC4C1VZA@+mV>j%=d7;{H^zQnx#8aIz$_FXgbE zK@M!u$(h^KQi{<@@Kl3rUzRApo9U&Z=AcBpO_h^BlEf_~QO2>x(vlk9Cw&rRlA3Ey ztwC0eOp^5t=vzI(AVp^q;)#@{IJ+ z$WUY4Na}*jq_@~-H5PUAfV!;;Y3r0IeC3Xpz38E}L5=ylRB&CbWKWYjDqmFN(_-p) z-%?}aId_cVerv`d`jZ*eC>qY!zEPvbKK9lOVP9g78dbWJeN?kfr(=DNxgLN1?QHKb zsCtEAL8JyXx#rtkIUHMZHE=%~1}AF>`mui3X$o^x7eW!wwPNKbVVKCeUg;3>iMe4I zYz@Puq0|OpKj+8(8r;81-{=KlxaO?E(8y3sHHYE+UJdG;U>z_e4E6Y$rEX*+D~I9L z5e*U^k(X3*y_l&%swEW0PdaQ&V*lzH9S+Y(MeuC)yFAt7RTj1FcXN&BPHpZ9WKQPN z7xWd^hDY^Kmr`qSkO5DYkWW0PM{BMty(iLFI#!Ruy7W5>G2k56f0ITTQ06;((EcH- zQi=NC_6Dp7A|J{8!)n$fk0(%XihuLeWWeUf1`Ogl)YO7~a&@>?TWvzc$Jt14mW%Bb zb8w35y3O1Jf9KjT!HK#s&binal7sq+T;$Bp#<}opOk@tH-7b1>cF)G&G4v`O%bF`| zW^c*EyzE0Q$6@rE=CPKS@b~sP*vPeK)M5H`I+J~@LPm0BHf;G3S(&fr-<~12@_*`R zy+fVl^7U47HC-uNyw!5Jk5Z;JRZ9Cm$mi`X7RR-vGPAT){7JoFM=i*1!-^!C6oJeMmb@O%4$WpUr zaDnqi?pHI0Q4?{~X8PA}AfHx~y2-~~<;_r6c|O!h{u<{dJKi*tqtroe%~<1~r$FY( zQrUV~fzM-Y(A!%9GyB|Ua{U$AF$jGbS9bgkMAj(sd&$(<+C+Yl>ng%Dxb!bI8c%b5 z)0=Z_pDc9py1<_HEI635;1t01#|wHW_sT~L&S~jacrIKY_%9=aZFT4As-zP8cA^8_ zWSzTO#@^+6mT_@-pHjI~LxHX;1qL~hP3fgT;TCFa?G1p}f&gq^6Np}e>7`sL5R+b0 z8~8r;nz~TuiZMoCH3qY`l85IS3J0?oN3*bD@&yzR%ED$(&fAak(cdi}lE^*^@(xF5 zo1x{L>64_AVev}w{NXBpU2HCUR<#tr4E9z$vqTfxGhFSIGW!xWEZ?`3JE1Nz^lJ-QI@Vq4Py^ln zhXT7!(gQoPMAq0V*o#ij&MJZQ!eLxK9Eb~(0&!B~kNEP`N8?)b@@d9jUoDz0WAA~H z{Qp`lB7SGWK7d|&A>{l6GO^)&Cff1qUK{E8#_RFLKOcMPfgSgdOh_j6uFk2%?V4IX z%xEp4)mzAkDE5prRmp&08|?73!KM8Q>?u^h<(3WR`74m13xH;00PLIs;r=85?mzso zaToiMM#TW(F?e;1JwuG+h9g?OC-u$0(ub>*HNrC zWI;Z{_U1$Jglywwy~I%G4}Vg#_s>)btfrHJJ#-STW{&L+y?N)kqiZ{IV8`gyX;00h za^ZNnHw^Fo4#n!F8Z@}4!P|+{sO7xno@9U*_oMYK>{r&OLeD+y)dkeFYLbIieRFY$ zxT*?z_kuj$- z{{m|t1uEQQ%6~omQ2V2VF#K1IO;P_*C2W<=Tu~D(c@@M z>O@|k-)kK68vJ^8Yw|-M$jmeEkothW)BO6^J;oNE&txBRjByI@XXH?8wq;IntHS%T zf!d6@VJ2+ualy80U_~`|0t)8q(RGDr)3=pkN0XJwEd`s#b!IcpQ4{~ z68#1^7yiiP8rm}p1IlLM#{PW7P2#%t7kNF-iD#?Or}sN`uw2{9=dDVKxTuz6R@cj%do~21CFjH_Z|c}r3qXl4nYbVH zzxJYz?)wD>|U~8k*s-2 zX(nn^EI_xvc^>De!_4c{dK|qHF6Kiso%)A8JY+PP!HtZm~tZ&AxzZ>!jm^&CFl z2FtIONYHxjSGgBGScbf5sXuzU(gS-6YrxaV5jt_rF+Bz+xz^bKjXi0#wqr=27_{#Y z!`yf#+^+K@g8rg8?CYvTkB0*05|%MmBr-l!rY}Rk0yvb=n^Kz(=L4>sDci}^`f8c< z+*x|^o~^sjeqO5$){Q3fey&tbIN4x3S)ivg6j(Sf0GW#dal2&z)U5-s%AbDNO@dIa zQw;uKO!pZ>U4Hhnjlaa+H$FeB*mpLH=g~*Q+=(~isUi#W=Vak0a|{W8=A#DpOZ|KE zqb>JdyQoj?*<5=2HkB*yxZWU#@1=8<%A;Il17m24qgCE8rrwYGE#pSm!rY(z0{(n{ zI+FF&aXr?Yxhrz0%bkZ(LyP&GZCch|>GKg3jW#^D=vFcK_aWnGXX<40nv6=w1i0Sl z;?4LzgSBwRtA^#NNqw*Y)jqPfV}TjgE(V#~G+BO{ljPjo6#1>vNnv?K?!{>sJHyVS1b_;=i+@IKABmBq0hyIU3QhBTz1H9ewim|lgH+Q6+W9*70>%E8hX2#El39Qq7(opA2!&t4M zb{e&N&(p7uIo=*Tuf-mzNatMr;TY#YSDpv+w6Tu47!yj3bLLuak)8g;Iq*%O!rPJa z;%w^vMJa5&Te2_Bq@mWqQZn89Qe@?7>h51P$i=VB&rea)-&KtO&V#*_9ym5zjcZ4F z4ld#Jk)(dlGRCstFpM6lK`XCRY#UAApBkx{vz$7*8&lDVabrz$vhQT|ex9L@<$zqM z?_{H%F$Y8MDZKlnQLmN^V`>I98hM?*y0Gs5jr+~v^pdi$j(48iU^?&DPxdSr+;MD$ z2Tr!5j{ihA1nyU1>IoHoZ_r>wk1)i|<~h|2=bnMRXMbyOx&!@=V(Dwtidx5y3~(e* zSdG`G+{&vmWbdL8ZUEysrg`f8-y#HqW*x5+o-D1%}35!20 zi)QKMnSY9$4@r?b)Q=q4llsP6-SN%jjvN;iHm9kvZKgZ^zNo>TkL+z@481p)8V5r5 zls^l;&v-G5bu1g^;0IF2fO&rhXT~wEH|k8x##;7tct*3Q-%1^T4ea}OBRd#MAG*ct zqnM}g{+>x~l={?*^w5jLyHu%t@u1ASM4jwgdO80^Cw+IQaig<4?Cz>@u?%&fr*nUM z%LDVz^IQ%vW{o2c%h(mdz2*q+ZC}5lUN-lR14im`+p0&;AoiOKpk~5GEC1sQmR@aTuY>0rY}xjh^DrBI+;T= zj#F20^5)+%Vjg|5g&M`xGax(7Xb|fl3FL9Qk+WO1nDg1=479IpMu&!u(lWP5Y_9v^ zmYRH`A_I$(KHzJgdZI1-EiUBU`oxo;Iz*kj$$1#sklf;=B3b3)i->?|thO-M*4T_& zzKtZ?u0&o{^2Ot{D7>1N0qwOs?6YYsr#G_pu$2AP)5xPO%EZk8a!(O<((wCt+4Pq$ zHG`uO!Jd5EKh5-@X(&0Je#$oS!+UabjWp@l+tCcwb_ZFc{KfT>9~_yhw`8Sb*R4D} z>rhWT>2rOWI&P!aGdHQ^{nF;)@1O=!pV!UtiVxnOkH(3I)D0~D0K=gAk~ra)1lRY$ zt6(i|Fpu}|aQYf|vXg3~e@G>zAD;32oyfx;BWEl$n zsvY{EyDyuMg?C!d&{Q zQH^9|_Yyg@b_nkL8HElzGoen&gU5^}((6g7+-2Uk|CMOiNG2ww=i$xz`l2pxl^Lv~ z{Kq*~2+zO<9{=WYpy%sX41afVQ!l;k&S2X_U!uy+I#y4JGMfsZ6Wv z4^L|p7Trk4)?wr~-`0}^^KZHG!4L25P`{7kw@FPimL7K!FRoFt5BXv@`QlA()cfQ8 zofO(cEaAnn@zf9$^@_&g@$}I8od;WKD1VnJkx|q|y*)M>O*W?E*o{2aRUKpy`L%UV zsE^r*S{bG3$R0)i`qTDe7)(F(5!7{!V_!cx)6tXp{HUE|b8L~cm`q;pZZy51=r2#6 z@zw77vStK%$v1u&!|^rPEdvFYdB4Uqlxo!R{O7I@8dfG}dNBhw_S`e?c9d;1=o`M& z2iaAagJ+I=d?Dwz6nn|o_d_~N^o7&eD2(dG9032{KXV(%a^-K?N8V)4)-7K z`yX_xFU8st*)qi!>z8U_-#rr^pYx#CG?Ji(#o}S-kEhFcKI_Txk?*$Y(|~&Jh0-Q) zFy>TZZA>z7Ix`Q=$~BSc^M7)T`QmivX!`DEU{@tG=KgFbc~zc`O5yrjR4Pq!hbN#WJzTANCcaal?aNXI-g{!RP-0^;NPK zkvndxMZu+XxbQsJsF>?&QY;JMiwUi$qfm={WkuGUERCd^k@=JRKJXz&*?R?_|Al6} zwrwhpzL&__*F&JAZsV%S^pCE zHf%+Uj@v*hP9BSw0CIe@JVKGv zSBJoMCj2>)y($~Xou#SpmV3f;O8O%Hdj>1PsxVOw;_dO*IZrWMM% z^id5_;!G-a{i^C7BoCqh6Nj|Q2OZv|?%SQdXRy4nmDD@jE@jjD&&Cxm( zZzq@3)Pg^m&zMdAZr;aWL^mN%dN&(20-5V*L%qvkF8CH12K9A%54AL*w=H>}V|zsB ztb+T&V3cd2L;gVeG7EXAGx1{c%M}5;$)Aqb0$VHsvfiF zQ%A1{b^4k@lf}b9i4U`a(eWVpufF6pxJKRAm0lcE z-Pqer?(BdLN9D}F3LYWpqK9>IJ*Rt`rA@$C6iL(C(Ih>=xxWu|fpM56y zU9`X{JxK~otOL>GblyW9PINZm3c0O8r;@}jPl@(Q4X)MIBYpuauwo=@cF3h7@=o_ED<`jx-X!E;bHqS$jYrCXw$awFf$ap6Ob)j5*6nK@SW z^^l{qy5d$ha&tjCbY1fhopQ;yPEC*j=jaRX90vPePQ?u|bHcFs1NA_Q=vzIKIm3@} z@?;hLj*~+%pPXaX=ZEy|qOM=Pcsa6AjgIm3%U(r2M2r ztybjbvMgv`6fcLU$J%oOeXDuh4C750@t!}Qo+y>3sBnwE$y>gX^L=eXEcFCkFT}~| zWO9^qm!k`FdsX>7*W`ZUkJse&e!8Is^+Q9dvfpbxePBGT)bEIsw3TjnwK@dT9CEY-I;HZ zdz0g+_Fif0ufmtrp)mWB3w~w7c#w*BrBK?+-gO^cAcbBkM(6r zDE!*8_Ep6M*Dx!4sS@M`{oI<=4@Jk8df0w8!GYJ|^QdIG_R$sdJh?xjPU1Mu|NS_A zPbb95%F5JpoECzse^bwtM0VkN)p(Em&76 zSqc}b@U3V$+B+EFbd2%hHGSS)lI1G7@7f$+q0B=hd1RyRzW+VX7(C)lT56cZSpL8R z&rAEAyQV!)G>&QKpSJYILr;&dM?Keni|E?gUhn0$x{TL9F^$vfS6yLL-};*Nhihuu zgTqQ=`>d(P37=M`y*fF~%jWJa&yPnxbq2 zWWU$ot=Eld^&*XXWv)03Ujx7F0im3anf`t-2Wm}wAI zo=zgwsd8?IL3X?9WJ<$>Qmz60{`%}_d`;QgOZh$Do+c@Ascn_t}Aoo`3C8*nqTLoNbKnp*-MR|4CfU2L@$OV zH+f9{?TxGMn8f*R{sDI!q26nydh`n1L*1NR?yM`jM!!^syE%y zyPO9a-C-=|I^$onI~mXqp!l^S!AFXQP2qXikXMSMNM0%6l3q@*w z)@_&v>(n>|{~u{*9n|K#wd(}x?gmuw1gU#z*G=6iUUzp_Ak^KEx?@RzQrAGJyCQWr z0@O=^0y+2I-+Xgs&cA2RbSfLd`%7MVp0%!Z-4WF^_!mr;opl6%*1cB-hGPC9I-SYw z|LMaz{Td#Jl?LaJ>5+7X^9hUSQsncaiJKnwfn*u&;xTO>>q0AZ*cQwF@}_u1JFs3g zC?1uz=}^y~{b_zrw}$M!tkH8OMUPXfba;G0i|AcC%wtXc$vs~0tMt%aWX+;8``kME z8F`Oy&6-^OemV@fL!S7l4sVa@P^B_^;_*5hwr9<~BpsHV4UH;hHX!R7iL8xnxXjwz z6J`p2Wi}w|8`*v7%W)#-_%Izq26BFr_rEqfm}kQOudifcS4+-4uuX*FZ8g8ej1hz%b*vCbrZfuferInW|Ds#$66qJ61pB_AA38=_3O?O z@|c-@cFkn@Sw~51?I5rFxXK=Dy66qfBzc{S?3ztKkHJYOD3Uk)`}yIna&k8JqFtQD z@iAwBraQ}qNsdy-zp-{y4(EMhC9_?Z^9K z)`$QM9Khbf0QNlA`ynRF2R$_O$K3YA(}O-(H-s*iVqffk7YNljf6TV_qpO48f5IE) z1Dp?K-T%>K&Jo`5$GOey`R@vVbw6MHU~OiORRBiRpcf*=A2a6qp^@GP`E_jx6j*flsiI> z>M1!Z*9dH_8o^$3Bo4CPFfxYTIb8%&l34E_6oF=(RSauM?vcNo?}nrD5B{uKTa@&Wmy{^ zMZU2Qod{!@f3=Pdf>+Et(9_$#EEq!<#0EMTH@iv40V+B9!&$tpw~+&CcUdvXU8)YY6Q>C(*;3I#E(~#(iu5oJ zd21(~R+Ax~(M+6bs-)a+H|fP(i3a@ImXF9Nk~!&AMTuwgi)9ZP#`S6oH0;2PwQuxX zv{J&>g}ejVlm(7TjHYjKwzF9dyYRZGY!+uaD7M!ukz-$rMf;On#%Tq%@*35TQlM0h z5>0v(%g5?`?d!~tEU!eDuOPx-x>4}Gv|f-iR5 z@WJ8M^q#z>|B(#hd9sHImXUax7>-dXgn zftz?AQePd?Qg_H%pLtPxbOWFxhdaNXL z*U5lvtvvpdAhXzGx}T_(-={be!|$6-xA*wc3G(}Byj-)>O2}6-kJS?7<2EvrR}2M?^D0-Az2yS8LF5m> z?8^RhbpKM}elInSmvDxSzw#cc*)Mg)wJV&R;?KM^gxDg4Z)^M^mu>QAZ@k=nt}9i|6+aNmIm27G-w#gnZy8ktPX@AZvp)zW$4%9KIlzb z&aw37oJzq zJ!142md*LSJgx=LaqUMp$*A+35B^X8?2--I#~YG;~T#=s-7O@*kkkO zYu`Gh$KW4Y6m4Xd-gxFFbYeCM>kftdo(CiJNF?8bM|7z*&cJ@oyEI##0sC{zV&Gcv zp_-0H5ANHV(k;UE;OkH6>}`|fV9)T{an8H4-@9l<23nKLnMKA!*)0=SxHj}O{*P~L zNDga7F|4<64eClyc_ zINclJD%Wo|m40Jd%B(5PW%48iG9Pih^_)47FS#z;roiAs3iv$=QAI3Ec2&tILaa`GW#>_<=S(1snp+DE|qnYIppNGuH%}K&$kEN$vSLj zUgiuX>Mrud*%f|x)7}pXvKKe`Y}j3gF74!Sv^*Y(m?S!=hekr*FcN{anDac(hzjM5 zIQNhBdh!KviM;22G9qXx{m#5sRqn_2LQfNp+{(d%EjgHUhyLSewS?_!CXS`rN!8S5 zGV_{R=6fmeGgE;yDW6pZ^nNwh`{9(yADuQwAm|C} z_@5#XIfu`h&h-3}3-PROM3v1(lw`}%1s>BT3wRk6XqRo4?>!ZmUfmxL_t8JD z;LJ|4FAiSuLuzj_Gxj_1YiuMg@VWME3^|@=WG#E~eJV8x@QZDUs%4_E2-!CodDRm*42S9F`D!1CP+ zuB}RBat*U=)G1N_fl_U(RMDVJL?|;+xaYNIue>6excYh=t-^h4AMRs$Z@OuhiBqioPF&Bra3lH| z$r~u&ai8f-9xg-SX~ml4NPF^nhxz9$h3DUxSlRzVD{Xhg$;T>m2~X8YeihD74pSqj zuPfw@8~${6MO0@shL)&NrXO>Ax`pE8;t=e9u7R^t2v!^+WBFQ#^$oe-UaUjzIQnNN zk$rfmM`snYfuA#Dx(pqNkLjK5#(ivT1|E-6cqZ*oc-CVNLUlpmY44@<sz)l@AtA3=zhx_w8YctXH7CDUW%nJRW z@LWLG--Omm&jDt#gA)~=w-s91+crsB>`RnepXu8QijgUu;^k5xYtLzFj1Ojp=@(br z;d9lW@6TFa4HA}-OBtkrg9~dIe2@N)4@KkIe9p{d4tH}hdkOKV*p#dc8J^9NY52)! zfeqi66Hz>lR?IX_WQ~CDNj$kq+it8O+bccKB#_nnt?+DAStpm`6Q!=RUe3}3_Gg1m z9_`jiu$n$JTUQ)?szMV>7YupiioX+>zj2s8D+djBC25c`A{2xAg+gl=j20pEZB^i0 ze;n%_ZaR2`>QS+FJX-!HYmvj*Zq^xm&d?FOlXZ;h88FZ0xx)Hihh7TLCY$MMtVOpc zKfgQ74V^tPLFiYLU+3b5E&@rPnIuKNYFyc?#*^kee@2kcJ*Gx{ea=;MrynwkYlFS? zF6T4fV|XZ^C84N4MTc6$^r%`s9$8n&6(#GKAsmkr_H+~1BfI05iECfdk=`l;W8Kqv z|519b_)OpE9W$msA%S*U;pw|k;kh@)R+cJVrDhuEH`}QsWJEKudC*iw>q;b=^@Z&N zEs)<ON-jKZCYcG% z#ev@A2Y;O9&qh0m=W#fcvczfDIXY~%K-M57{J$vRrSON<9X}l6{%8b`=f*vMxOJpo zp8J%yd}gJ@Mxp}u_;!yY;Klo6f|Zdx5%=F**H7oOb$K7|33&fG%4fvv_2dO+kfScg zS)rlyBPNjbW@bR?!7Zd~VLN&H!%coY<~=&bRdS4+>-4l_evk!oQn_byR3LjyiRi2Y zFm19wRvq<6JbSV2N7D7zCII!g7s?2v!?HK`H!mYl`7q}p8%N^ReeUOn(&1Z)&f3!S z3fo`8#xkjNJ>>wWv!UdA-o$79GOHZS4o4DR;B6Xcy<>&f3K4j9(f65;l`F?#3@JGd`k^JwBL}MS$kFiz~ zmJ!LmI-mFbQV{J(2mS0+9O63TRe+KAEixSMc`W4KkKHk0-^wx5sZeb0*yTogj-t=JWh{ z?tS>2IO0uTBed;rK1|Mrqjs4#2GR4 zZwd+%c<%6d-=r<)JqNHa&GRQPg`QEK&y&6A)x4z>Uz1LnI_c$;N-x8#5+zC>FXuX{ zP@cZ_XLHo(mQB8UIeQ0Z)HqR#KHs|D8{xfq z%SRo&xTc=jFauQ;anF%!(?P7Cu2y(9B)?dj&y7DJ&*etI+;9sl2)9wYC6L9DBmyTHCkV?IZ_b8Wsl6Vu0%i`&C{ zAz8G~!xf%m_-y?|KhV3Z1Q|wmeqL&#G#L>uhYHyT7?~(tpSWR4mOFlKbcOXFSIn7D z$M94a=r=N}XoCj1%23{~Ll9>l3cFDH=UGplvp|Q=tZBy|(P5(K(RU&1)I6TmtPNl7 z!}q8ZeZDCf=s%yC*ksGAsFa>tc9XHBFY>CD(zE_4GN7y2uee2quup=x-DWm;CH76L zCrN+y3Y>Lrn5lHbfCRb{>|J0y?SiLf4GJSPIBB85+WLHte$sO>QN#N<=ekDfu|I_@ z;|V=Zc8h056J3P9oVkj~Kqwi{r*$&m$Mwfvt~rjrpwolLVeGH;Y{&cb@#%EvJXLr; zoX4Dk%s9FBAYL5kYB0{!i{-UM>A%_)o9DWq9(m7)N>{X6#g zzVsb)e&cOCT#+i5?jmv;;ALq-Cu=gK94u2tgvgzzkyYtxo{9m52<_RlF$o(tBpK;#( zaTrdXOh#=t6IKtXFK+1ta*}&2|NL;?Us5postGc#iOinEoRk}bQ1?A^K$vGbzbSJs zYT0nMiS_ZG^bDS+r_3z{>zbI5;8{lwcP^9At zBN|Iz&qA4W+6QCwtc|rGFTF7fi>Fvi;jo_@YJZY>SR0*@5*e8U>@^?DM0ut>h` z@WzngtoJ=j!He4DhBjGAN!fe})-ca^b~yAttZo0!LLKstBaOesnmIC)Duv^0=@fMA zkcIwD8b~!V=8H7m=rJV>woO^DV|{vD4I8<%;IGKaLFn3zu7FBLDE+f=sHm=#ZShxD z_4S5+J3WSjQkVrzUQE|OtnL4b|Jy;B+c*q(!S_FwJYaGYXdAk!)bUB#7R(+ zo)@+Zq-XF@3LYnsYrEf2vOg5b;r8Bm7e-Ev|K5H#^Qj$e^omjgINc+$o+-wWhRwrJ9e-(`G&{o-NIUyoGp}#2feYD`QQ)u%+A=v z^Fi4_jEz{!Zp%!c(_v_xk%B9~==Z!~E4?{mu$^^?PvK#BpOy@_?k1$UGH;!;{Mnbi zaeP)7qL(qBx10%4rmjS%Gb%^ z=f16hsmrkW4-@pEi(Ck3VAOvsziNS^%4lPRm{vn$U&3OP6nevXdM8_4Bp`OeZ5_?+T?(Gat-r8;(=4^nEWep~vrrGTWy}My?}AIW3GHtQ0Id zX+n#!wZ)elYtbljh2xo-@FWEbJDX55sGd|h!W`jxzOXnDhC4hT*4@qma_h?KN=4Fi zurFTmd~RBhf&iZ9s(Q7h^VGjmVH$I~N066HV7@TdtD*gCNx;N>Io5$W;MU{^)%3JZ z%fd8wJ5inaBiWpHtUNv(Z`rF!2d``A2BKO2SE9)^yUwS#^m7VYzBXZONj(`tUbtl^ zA95vODCYU2>TiN`^?IU+E0A`he6Xx>I5M46P`-2)JRdZY!T0m!-WzY|5}1(`%zUqc zEL`c*K%RXokxCQ1@mEQ&=;{>I=h{e5uCr(0Ux{Nr`&s{RST!Wy9hikP;r4QS?O&-$ zZ}%o%M_pOVxiCKqV`ke({+B%QWlnd_D!z_W3KIGCHDA_~kd_5f|B^RO_X$Iv3(4%8 zXQ7w6v5fclC%qex16>)8`s71P^L>8P&Q^wa7fRV4zIaiFyz`i3bem|x_J(x2a6j=X z&Kv(&`|sdOZ)xu=%skgbEcAu)GRX(YKg03-Z8D;VlUsaOUk(~dWCVFY&FXLj@H`1` zn2j~Z8_VY!3REBmts*yit_JzjYhUo|4|&^cW@BCTL0-mo6TO_KVtM=4 z8wdC~zUBR@%YNoZziA*%$sJFxM?Ud(7}iE4W86pPp_jIj8R~zs&CUmX74$GprdMQw z3BFtENEZF48RTA9z6i(f`Sd0nBp*7Xp3Jr|ix=<12RD=B9+iSY08VV z#!S5yJN0QuBGU8(dcm)D`?hcvXAWk#jK{ZjL(BN{m`Lywa>tjtTt@Ot!}B^{CV5h_G( z3dRPV7K#P*pj9lv{RIc42lQH-A8Xi6~BV+OrxvrGi6jQeSEc*H*bW_rz9sG_9*2IfjP zVMZl6oh<%bw^rQSRyr)|rB0~)Ybl18VNIh-I_p&AgUDO;b5vpKUe;wsYO(tddBd9} z2rND<&zaBLg1H{Gb}|=&Tw(L(W~gyUg!#^Wmo7sizR&Rw)3AnoQ*U#u#Me<_9rL@b z8fa1LHFI50nej`-{M1bInfqAu=hfxx~ow?!ka!%UR)c!JZ{Jy#PJYlw#T8cc^bU0(L=YJ zpVtj%cx@qfHiN#)_GySa&GYJEoVeasAuy1>xrWT@WQ|-~&5YqIweo?i%ZSWi&Tnb4 zp$d6YORk+;AC^ip)cCtTh`HBV+_&YdDPOS=zFGKkq^s$aghdX(_TAL2Z^7l?yVdlS=Vjj0H9j~gI;afFI_B38=ep)Ok zlZFyc&WqEV*}c6A?KTJF%4G71ypGZq@cIosBBpvO)ZV%bJJPkR)jmd}V%Hi zN4yRpuS(AGRv&sTb9f&c7c2U8Ds17uU+Kfw&wY#;{QB>WqvdE-CusgGL;DqRsNI-c z>Hsr5Umg-O{hM~=E_K_;vrkWl?+RK6r`&<1md>v5P!%!;j!b=xz$9ZE`C5KtoOjbq>_So=Zm0{wQ=LYMu z!wp*#U6Ma5@(r<-)P{pTRXzT6wDj1SQr^S%-zvje)dNG{%BGHgUt1(MUv{(8wM@(8 zsiy~c#93XsILu8iDMbnL!G<&NxAaooS|=+)nXmC$Cl&U@OXcM{dAK4@PUPz8p-PZy zUOL&VkCt_!mD6Uu)My?nt3Jd_kLK~xZ4>v)H}taZZmcZ0q?6B~dTDnkR+=y)BfpGR zCY+9!v6J-DDv<0pVx|M8TK~-ND zcr>6Mp-_)%WrVU3f7nAYF+SYrwh(=e|~tD3o7zHJ7a7^5(0N&R%&=57r!( zGuw~7<~Z)_OGAUP`K)4qXYJ6NeV(0qlpVx6&=F<2 zawZn@@2gqsdu@@)nJn^(>}&V;WZmX;1}+6K+u{K4=j>0PIL5!v;_Pf_IzES|V`$5! zl0Vl~MsI5_OPB#C|LjCjM=hi8sl@0yRRPueltHc-DN-kNefZYn5-d!xFehOUQQYA>Sno^s=x_1C9GetCjY}M{-qQc zzo|%C^*2k&_kZ%KLb0@}rhp~)NtZ$t2>N6eMVTV8IHJV7HA~^3D$% zdicTmYXHI=>5h5zpB{Yx4yOe`9q12ty+2yJ`(f}AUtC@4507sF=#=b_@t^!r;O~d1 z{{ArC@YxpY-@Wz)ZG{X|A+|G+!ldN-0zL%-gHY-x*Gq{&p0^(`>M0o{4xUb4+I;x79-NvwnC zu|}VKi>#D^_3(PB2)8%l))*t2&R{Ms8LXz4=#N`NW??LS4KGvC*`D0MT=G+kQ&CBk zipu=|wt?Ozn^dS*(%m?Yj<{1P7^$N(?k}^m8mA(kuVL_Kmi2bB2gg#-wmEx7J~{Nf z(W#i4je-1og>qRCi)_4_X+peHHg;6WM!9UxymmCfr)M_acFD#GPtL4;WhUWMGFRJK zZ;H*vy6>E49hHNj^O$kDDH|@ev$381@SWrZ&aTTr(h}xLKgq_W&2(?vpciRxHafB= zvxjxEMxEGm$jHXeN-CLLsFt1297XG(l5zWOnQQ1I!wvM7?qtoz-9dWYv6rKZ++^`u z2kCj!Nv0ig6xr-7TMOLeXhvf?7+oZ;u8R!m;3{)6U8Ve97pd0FQRa%DS5->P?ph)r>M9WZRe|0a z7C6dly#6ThY6jg}qC~K_0vmG`s7-(AjK<`C1I!Y;rdT|Km1yy$M6|V(*nUch zl&j<%&1RYHRU!e+OXU9je{y+63A2Lesu)lrX9g6@xT<87jS3_kE0Sgd6;QubVr*+> zg3{SoX@x%;&GW-$dQVO9%(=Y99J5M(m|7zMJ8Jl$M|ozLvDTH@+#kwT^lelnV==@Z z_DKOqeNSeQ*IgXHZ($!_*v9z5{X_tKK62*psxJlv`YWgt@_-`t@9AEe&#}(7BsE>rxSaQVtvyE*e z9>#>D)uRaf=}b1bJ~_uB^fFD2L8z2Mgj`}g9agm?k?qHPcdH%fJtQ0kGug#q z{Jy*}Jg>?b*|}tjKhVcDJ(9Cm%xGK3*XHjD#o@3BVJ7v_aJ1QD#2fbgCXS)s^a1;& zb9mkKBq!0B*O-B{e9aaejmWU3TT79O#z*=8&*61gGnMN*BO2!M8cQ@{;lWhQxoboR)(q#(GvW(> ze`g|7#Qs`Q&1|H$%E5#Lp68*g0|qmfeMC0qlNs4Ghu4yAHnxo7{BLg)GRYy1c}EVh zCEbe`v+%l74!jqTcS$nAYg9HG@_W5*kn2b%+xVQUaf=)*`jU+s{CfcTn7;pVkj<|P z$)OLjZZ_tvWZlS@{m%%HR8SG0&(r_}G+BR({YJcFOPz?^@M0Sh#ga{(a)KVUsa2VieZvPyp)=%mElFP@{?=9`oVg+H%l+u_cH%EjQ)wwak9}*Cv(rm$ zv8s^BIox9s<{2k*Iq%ZuE!T{nVx-Z(I7xBTi(`!hN&d+7BD1ebmT1K@H%9z!>R7u? zlsO~mW#lZ)ovZAPS!!kde62ifuaof(39{W%Cvek=vM#eOYjQofRt?|wE|~Ixy}TqB z1Z{Fb6K6Mc^r!EFJ+zA+WI|H8CLFIqZ>|Ab&7ni(sEW*u3##qr+HZpzI~us+K>&S9 zpV?m;@64=P6^1#h&@xOsIhznXJ%4V__~6bb6ktwTjYYY zVe}@FSxBf9g0e{(G=3j~g*Q0g(m;c}ln`uF)7kP=gBAR`Z{>1Pe-Lmzlku0OeUEav)h)jT@E?a9|{BfH|40aaiIYLYdq^eY{U3(^q8 zwc2v72YYr+M*-J@?;O*S(>?>nUYtv5nt{g4$tdklr#p=GuihEx_J-MIBRLbpzVGN- z{GFb!zfN?xkW)PBnu!CYGcj}``H!cp1v5v-df^vRnn~voe?~y@wF^b5NwuvoRLX>O-AmiFD6*{Le)6{2{!_eKZbtc3%+Q< z=g-+2^z$}jCZ@{{wx0q|M>P8&odML3rM? za{ry3Y;Mp}G+aknY_^sCMG9v0l*nf~z^vPuW$s`F?$=dfQ#JBK(e$;=;GD&k0Q}h& zfJwXj(RFqNHn=l$`W%^=nUQeKjD(jL^QPCP!orK|)BCBou`m_evuKq5%J~9+GW>gU zkn54d*|!|lhIlSF&B2GcNfOXAUaVFnl9SQPp?i8sUKlSsuBp*_mpc|#XC~$c71BGn zq5=2&k>ly3)rX?+FZaHI8r&YM0p@6M>LvM$Ejk<=$a|ME9yiXA#o#^3_ES1$f9Gsl z5%-;DX3ccSL^AIS`$zMDis`RWwH&O!=GbglkB5r5R!#-Z> zRMg2rgBmLbF(WgB9w#2#2tFtB_q*aX^F6$yLa^*BS&)~Zxbc8|dN_SfE4k0!uEQ87 zW;*ZUJ&${5LrdlrY+$~?R{COjkGgD`i91Od%zq}E&D=-aPiaC}89^8Bm2{l0 zn2GTYN>3|yrRSlkNrT=CGv z8PT_{(64pFbw^iJT;z(JJhCbE$?NesR*TQB7onk;P-i*Db>l4LbUl*8br{)`PG7Ph zAHDSSosm&rLWhI{@9}-f%Y^ct-Zc})$%3pr#XQqkg=fk*g=ddU@~0;Ht*XUK{AHck zjv=SAHBsiRh?n}z$Xr><70u`;ux~;?^I~Rj+*f1kWHknC*PvzDP^^xjHY|Ykg*JNRC=~hlEvrzSkP!ksU7MdrzWcu&xi8O?nNUBh#C&=q@$xe6ya$HzT*@ojp1 zE7Fa)hkNa)2pmi2-gN<)G|m}~j@U6gEuG;>1v|tD- zZ45wEJ04Sj4<0V$J+OfL^p%mU=|-@=Mi=~8@^USVcw3u(z1w`Q?oP$XAx3QdoPw*) zIe6VG2P3=WpuvM2G<3{`GuQLm46b5q?Ji?Ry2*sf&7^FSyV!hfCYze_nI2y( z?TQj3S8-oAPl?YJ{7|7<0Ls4bL-nu#v|Hte1JC{N*e-(mD$Y&TC*#Sw!J__=7^sNE zVguPu?%zA@;|vz}^Z3WTgqpk_*ZZgV9No>ma%avpW&7k}A@|suSGY*qip|8z+gVEa zI*FmMsXUBxl8s&YUQ{y6_znvEVA$`f4d%cXnVm>b_4Twa|%4FVmq#`?xb7IfAml~alf@?-ZS~G*eCI=Ham-W0w zHl{Dg#gR5S*g@trHpoHjtz0GWv09$}a+Mg?z`C8~IpaVcwVd;q^q%*vuj113suwY|0DvZUqs*<_j-dhMkKH2XS6C6Z~ic& zlMZH_OvUxXWM6ZchnUa#u)4W;Xvul8pV{;$xk+9{cR8NpBvbR9rIoIkOz-R>%g0)v z+CR>7@cF*dS4lUf5^r-$q-HU_PcQvZi_g_W1!r;LkF)Fjklvr4R|IED?7046{io}& z9SB|)iTh5S}>3OD|2kMG&IbtngAJaf?a4L!`9;hbJMQQ94( zt2SRRgMH)4Pmy7s!@TJ%7i0yvq3k$UXt#2{K0=KO-^ep2Xi%>U=hL6@xxu-j($je# znxNsVln$3WlVAM9b#)D{$=k&LcYW?MDif|Z)9FXb!1u3YzmAecd(S*$a@`;5DLh}+ zR(h_TtnfTXpYBoejBke@lRs|~CFRml`Qgqw`i}&;K)zDK)fjct4gY4Uv3Qj$c3QY% z{b(mNvcLqjI z;Y`r%4BXG9-J^^P$m$KCBeqLr@`L2{j&|W}z$Be$dXd?C5+@GlV&!xh z&Ma)B`*1YxgGoFV*5}9Cs!`nD6^5a~xMQQiyZOv6_Sc{dpQmsAf-#S*d#3~Req7R{ zm5(0Tig@%^=$U($jzAt$6RzW{*UH3_A|BgqW-BkD+nCR<*$3&Yg9_E9WIVV7_ab+3iPFFc9P04$1@QRm>i*#~h8)rMnd*-cj!F4|u{JrNw4nc+Y z`{>p*xc=9@e<*-i)1KTDmSxUUP$-`D2t~;qJuXgQ|J6dL9ZN9>D5q-yJ_mdyw^F5yP6L-nR&fUd6PMKHOgdd$Q=sKMk&x*3Bt=v<3lg$<#Y#I?t}o%DN7 z*5fhf147nv-NDc8(sw;JEX}}x(iw2sL-)WU=5g~gE15}mKKafTDezs!dP`(O zIq)e@f}i*x>L}-Azoej50~56Ct?8F7mLtFEU%L{Hb^Yn*>YWA4GPZJndBiKqu{Pa~ zIkw~(olem!H=>c;QT~&y+c;;`oqof^o&8$Q`?G`td<{+=})0aw(YOLH==C zLuoVmpL|>4gFgqDFYLhMbjw0qww+Y5`6op~eDHi@7?u>KAY`WrNx$vn{iq^&*4Y<- zdUM{n1O0A`nIC<%k<1Rv7t4;!Y31?M48&4DPrHVnJ?`N~n|R@ZTqsr2rJo$^DK zMf@DAle=W?y3~tWvd_6#$~^PI9`*oYELnFH{=1Eh_!|Do-FiN7?G=usI;r@2$OMO# z^`!I7V(Hh@2lnO2XU$5+yJug}O>ZscumWm;e9*ZOy=*6vVOP$CP3-$j?fF-N$&;?W z6ONxeuX1;okoCz~cDntOpziE}%nQetYnDANYAkz~{B%;1Asy8Mt7M6k^cFa%8 zvKMbR1MY z^MN{&^R>#xi^3*Sz2QH}@8g5NtWlr4mW%*$ou39bl*nFr(#hT%{?+NexJ90k9Ad0@ zJ+a?k$O?fEB6xo&Q^N?4FIgxv!b*b5B*>ZEeog4TFc8O|74gG|6RlUF!G62qD^?c zsgbx(%9pl(2I244aO^DR>(}J@@W5Ka))YxDz1vTFhQl^C1xU}r!JGCH!k)u~k*wo4 z;Q1Dwf~u^AthK8zn^lD}>YNXPVwrQ{L@(zw6GvyPWbC0LDfA%MxtsR^XCsDrGtVo# zfh=bJ_-BPL%;fJHH>0o9ota+m8p`6udD8rk7j~5nL)G{cOl?4?#YXmLJb0h%<%6qp zcs_?GKtH3W zwUjIG#uu?$=Ghn!hyLe*}9gW<4JOe{O|gBGzC*KvoP7&mbrTW#OaDJwv-J= za69I_k2m4PR$HkQSS;!)%ozDa|K{mrJl$);aE-NWdRinWCVDeJl|B{TXXfa#u-y3& z8Ea>Jm>h)OtF*WhoQ5s7^!xvb6_*o^*d0agiG0wF8;{YwANixQhegZz`i;vqIBlgR z*OP{`P0UdJJ1Bos9DxZTjOW$C?Qj|{H#Ea;?-2=YQ3 z<^>1t3&D72-G6(BP&kN7%GPLm(>RAV>urr&MRVqTXtoL@!1;iJPcZlV*s z6&kcBdoaQ;4Nf*@+*uVZDW9Ftl=9oA|z|ne!3IT8%SjgTI=Qq&XsAl2q8ee;Kr^ zwWwRjyze&5vkr`vo6nswkNM6XGqsp~iMixW6rNN6MoVie=AoAaqsuTY-u+8MbajQN zGxN9ZxbpL=5)9WqI=DCB@dVO$X^NIti=*9aO zrAC!D^gNPh^q#>Sd5sy(?tRw$Br$UT$cXER9JUQiAI_$DZ z!_;&hCwaghT^+EKykXPPIyB0sM|HB9p2cX%>*0v+0pt+L^Y)*ghB~v%uv{J`7u;3Y zKQ0($ZqnPhm9Hb5eVrIhhKv2Gjv?4z7>CVP%)z?O>(us;6jWAW!hm2X`Tl&m`xuVo zf}6aLmN^+tnDvyIBF{OqU4zU{mKk>qQL^|7J)sAKu_Tbb#VO=i1I*CxWiE3cXH4aF z-FG=>^c>P*m{Eexn+{5ehCR1n=BI~f@q+*U!HYA~$|IuTEc-bg=S#j11H$-z=9+OJ z{je0pI^t492;T5KEHf(&vr3!MVCWIC{Y-x%_l^EbwP=4a9kr*@8@nS$TojI&_jW1X z(JyIYkI0kre`(}cCp~e3#nmAEs!pfJbiNKf_4W^9#C0F%4*f8ziv&QI&CxWWAo`<8^)Y&V~i~4c~yTGb91|B z@n$f+wD;*(T^=hRwm2j9{4z|@&=YD*M`@n770D-#uvDWUY#A=|{<&%zulL3Z&%TI} z#f_X{J0%!9|7yu?q@gwW?v0DI@~(k17V>zk)3k6{#_N>Nk(A9bVp`~gR}X^d;i9kh zPC7EFJ3j) z8C#YtLofF4%ma8mR{o!TSTlt}5wqt?e9wROaN5P)lK1Cc zGjv{h-=pU7)rOMKjSOdZ95Jj`zq>d#{dA|GZ5<4I6rVaAI#$ilZBbLhyg}Tf9BaGl}P_2UMss&5V6OCK0I zEG(bgyj>TAdF)Yxp+WM+?wd||n5J*_SXcSC!S{H@qs{CY zkB=AYa`93H9ra9HwjK`%|41^of-zD|9kY6(@^_>E&*vcvBzG#O_ER}Yt!k>iSDdI>N*$9;=RnNfg4iy(wo?gbA%IIP=1w~Go0*4$B=tu zZ~0nldU--zFq^z;U0Zkb?W;zhP6cyAHJX}L%&TS3ySJM4e)cQsy2AOA3${RoE_5>N zDt5v5KWaGrR>6{c`OfcD2A8`%F&48iN15DbdYpi?M&%$MoZ znWDq(08!rQ`Cr}({Q2iRcO7#~^%xPxETdCeG+)HE0{hp|*L4V*z~1y)Ju?Hy zJKv-ypbG!oo=#*wr^EW_Q6p7{>U^!4zd7d+M<*|zLygMmurY#p)W7)}HQ6U;4|{P7 z9cH}IVRj=O=AL40=R`W<$Sz(VoDLy}7{*%98xy(3({wem$K=DB)bk(dnDLoD20mv` z#bwa3myQ6|%Pxd)_LdB!eR=kxYG&X(S;x(+6KVK-o%|&Y@%uB-Yb-M?Ea<;z%ieVl z&h0i}?SDA?)@w81&ga!3_Q3<&rsJ(+23i;#_@8nVzury~Y40L8Pd1i`O0_s!I?Bw7cG9B-b9XZArKPn>4ll761-Zq{^>$+Y z*-1{ncaZ|-DMh|yrnCncteK7Fh^?J$YtU3u);Y+WCr)z8&0Sh8aF}3DzmU5++ zStgfPVwY=)3_hTM_3C1o`&5Akp$f#*Q=m;ukqj!QfHUj1F1JeLO-t^$QWWsL!Cc$} zN-R?riE(PN#E_vXiBcjinQQq`%+4i4)uoOSks5Mboy`)whkm)iWU)T59=)$bI^|fP z%}FJm{P`zQYt3RPE|kCC%-C(`2dnmeu({!f=oD{ktn7z^SANVuVCGY_A2Vjzt9M`> zf4eX4exy60p+DXP(*YDtkDSRH&j0+eV^RR(%dsEvmfnCbzIfNfAA@szu!YRloqXm< z5AZ{+IsOQDp)+WdAL6b3&|VRM)v12?Kct=YTa;@Twr8-ry9mhv!9cePx-RT((O`?Z z?b_UsF*AVO#9(((b{7nGQ8M54zVGoJ-yiV(;Gx@%ILG<7`h2M$L`JY0fh4W*xjESt^N%#_jYd1fPpSTTR8V-pi`f9l%{j&Di{-uxTkakbYpFMF|!{R@YhGl zHm-`o(rCII$!=Y_OI~sUIW7L(%?FU%;{QMLnmj^3`WGXaWqX~uP0KQ|y;c^QJ~m(w z`zVuUWYOB^=*T}`ISc2#3^>l7Fn8E^Vr78Yu}pl@XTs%uCQ3>&abh5OtebT2e`J53 ztdnjzbG7`)8dhV!q@xkT)*5k;J&KhZicmbah~6l=7j<+lRxzU6R3k3!V2>b)oD_d= zR!2H3YS01YV}yZ!ZamM&3Z6YRujr6_K;Ei_kv#`yJI*e|zAJ@@9Y&^M4!sV|*~>SO zm9#8E|9VE$sW4*b1#8L3P)T-qN0~g|R*LpHNYP{V(hoVvszY>4y|nx0G>von^pGJ1HIDEK9%H%lu(h(p<&f%6HzU8`_Kcb_bd5 zsuH_;tmX0hbR9ysYGXUGDpSdla9gQlY%hNu=`3H9UF5z|fw2R~A97}UcMI|ram;kT zr9kh4CK)%#B%``kh|01;9`YWmGQ}jD`Y9lJ72>~*eVV59Pt0In>mRZZbQVph^IOi% zS7Jte)|Yyg%2j4p9;;!7^|eegZ&bNh2apk-qJ-5!1&RilVVRu*6V6n~!Rckv_>@W7 zdomY`_r-A?-CZku5$@=Vh_1}SV&CxURAxDL^F@bE%yzuM-dP)ej9cf26=ebFH;&$o z1%7zhAOPzQ`{Vi^e?0l>i%JXpaqGP|rtM&E^(0^P7(;*KS05}Z@x_I5AAH#yfQ!tH zdvwwdYBlfO!@fvs=!+>D_L+J!d)kj~)HBhTZLdL~TCDjrEzs)+w5dv6Aj5Vmf$D)wKd-LpDI#tJI;cu@@^lL}Y zQ!nzsi^(z`priC3x=ne{I5ptC*B}drCm3+sE|Z=e1D=g#)=gp-y|T<;&oE#cYeGla ztGl;`zvo2OV=CF0ZoKD=2E01V`Pu=Q2%19o7{7Ki>sCEqWMcLX11^51pRq+2RJjJM z2{a(hHw*igF_R+Ni0$uqKYcMG$g2podEKv@Z^Vp!22Wb;Ua+Bmdb1<>>7KfM>4P)RqzAT3NuXL-Ctun4|KbKy8>tF6ui|4sD zv)Y?JDbOZ;+s&)#H!rQ|+3Itq`}YE^=&vNn(mF{pa7&WVl_l?(H+_#jr`*tF>6xyR z8RqnG5pI;l3AzNgNd(c2g=7e>TOBALY3`ssOp=43>&$zZomD?`tMZp2PDje{j zAH7u*9r3cW3R!bi=sdt4J&X>l%{ky1dyLaKzt=;p!uvoKIvlXa&BJzl#yY^7=bI&k z_E@#k9$u#%(3yKf?^`PPS+d8}(h;toIY+}Y%G`wxxcN~9AMPb@mN=r$Wad({|6|e9 z9!H+AhINelMb;Je%}^tQ^^t#?g+ozDCh<);>Q7fAeTf?He{yff{h?f_WT~}@QVAv(m6aQm9RHi#Mzj}oTEwBqxbb(9Ogc4*rr^1 zD%i7akdN(N%!01PJs$US{U+1f=#-D#^SLi++1}(slegp27a};|%kr)nBcoaDcsZ16;n7 zv7V3xd+raSI0F$egFZWJ@_J@P7|C_~aHS7uHM|ftv+ZTB%1M&1JIS8&R>$N1bI^Vj=h!$Uv(cH>-0b7oJcYEU+j?6_Wo zCI>W#yTs@Ca1EAyFhJj)j*zc>UY^K8JMLx1)L^aI!-$79$#G}W)jWf2^-elF{-s~9 zGFirW<~h@&9DRTsV=sH@=hjhbL?{tnL6(1;5`GFZymkI9KPD)!MN0Vh2Af6DbCFTaebg4*3Jz;Vh4X%?$SUe zGIM%Axs(_5Ta_{cjcaOi&dn57&%!n`_=CxWc}$??!j}w#d#b zyFpGqoDAb;7rE1?lh~O$N=b}^d|qQI)(yKkBrhU@4j z0}{BWT>adLA+w6`sn-W|oNYvWRw0&5Vx9I6t=Kox%Bb>GIY%C?&@ojWzo5@9+!6PA zws-KPmx!GB@qG@s(>wx?ZbzU;f*Mh!JS+F*b8;Ykgd6EdIzgt^?oub(VY2v&*$!9 z`YZkNaQ{AQeDpSrj#YScD>uPitMF)6M%I#kEvMlJB_l{D=9?1aJz0=OT+jOsbVS{? zoCmdWf^%<2465aXR_2aSjg5fqOFD))U_{rJp1p0xiC&QZS%Ddil zU6qhQeM$e|1#<1DStn?fhnE5Q$R0taaV^;$`kMYUC_LWqeOgS`p{P{hF)}Y%(zhIv z!WIW*9_JvA(%U={0o6GM`5@QohNn*5K4t-{aj*zr6}@0yQ#O<99TQ+R~VR(SLw zPh`XQMg5kpjdt`91f@uud@?i4CGi_iH+5#JSgq4a`eyD&4zRxD$Nj@7vLN^E@$0S= zYOdoP?B)pc%Z7M`6lVCHoLau*n2#olmGK0S!Nd4}vp2CS(O8#xbWnWB=Z zwe01G$ypAJ?j%Rz97N^ZMdl4s;88UNRy?YZsyusTve$Wm9+irV{>bVPh-AwEe0myy ziA(+PM<$(rz3FAFM2~NU21=esKI_TJ?I9mA$$*wavv7-N=Ol82h8N7i*8GRpBM-OC zh)TzpAxAFFelqv*VSH^{Tx39qN`ev{#G$vHh#v-3^2Ics(?0O^= zAIyTkodIR8TsH=>J}`#o^T|aRJ(#cKg%LZi(anC;2=lT|(qnKJ2|sTuB|-ems;H#> z8(Z1(j@ilmmCRf-VL<)6`*!oAPW_t7vXGuYuTy7!l6;WTR~sv2ZHwONSe zUZe9a{)jHZ*ZD;#Ty2Ca&s_nVI!eFk&ddYqC?hBLkU<@7CD2+W-JO-V;Y{x`vpTnM z&ahyd8SZlCBz*>F11FEb%ARCm#|7f-5zgff2*AJd==c1f!Szbp@Tdo~1x!4PR*S~b za?S^Ey|TE?y3L3zcn-_LZMrOvq_Xz0sR+;8aVE`&c^6#YgZ%k3&p8dw=;gP+PTacc zWY7=2+_g%PCjU6%_EHC^|8PX7b1Lj!uEIyI8?Kktcv532!q2GbC1m~%pVx>`!#!IE zw}r{5dng%lNRLT7`3#!FS#j=#1Jrq#b0!zb%kwa16TRY_$>x*$>PUXM>j2*GYOY<2 z{>SE5HtD3-GaV=8b@C!XFI8%?p6;cW8OJye@F(+yxPHx_rNX@}4ro=O!Y9`V&d{nM zqarY#YuMw-;p7L@2)fHG9`56p^R>82G8S&cM<1E((t+;aoGw?|q;ncF?6H*+$o~)yyN(W<`<=E=ZCMyHn&*kP7-8Dpasm ze_caLt=JzDS_Z{c1dU8$e zoQuAr$eCB+GjSMM%LS|%KVls?j_WA7%KLm@-W_AVmh7P8MTN(W0jUybmnz2w>!riq zB(bf~$w|kfq8O*bD+fmmuHp!T-VVVV9WeD1^OsgKXZk_}A}-Psz|U$=ANJuh)Y!UG zkLGtc-_LW-nIUu`a{n=XtsYx>e%Kw6hv&QVk;XMXKZvzwKb|SF>4xO{@$sC(!;D;h z*A)tn+GHC;>3bOWAVo&>Wq!d-o%~p-lO2Xs$yn`(GqW6V@fCU4ZYs>UtHSqw9k3@d zg3lMO?X@CsD~VhquO~Iv*OpvMmj`kU>y(VC<8|mXifjC7_Wdex9eu*tiEjCLnU#nA zQ}Zz3GdcK!TrbGLE22;kpWq zxhI=^M}?T?DwHo(!KIQ4_C67K{F6?Gugs?USB?2w)rdI6_h&QrJvrnC^0|(#)gk`3 z9-Y`9Q}L`-YeydQ=<{%O2{XBMdFXwKndM|X9nL5`ws|N$4t?W{$ylymRsJ8(m}T8c zS};fGZarUI8Ar}&K6$hqg;;vbLXzhGkm+xI5#W z66-6a@_xQI29q0FQ!f({Im{7W)Kc^XrQ$=MS3dbN-8FjX+S8Lb-$J%dDVMtIy%3ug zg@#`;@No@msApQsm|JBsafBBfS?79OmAN0g3UH@!OR3Hr=ZWMiOZa_)gEE-WSjhFo zQa%L)*xvlL&OVmY;te!vrvSQ(swKm3@Hli5^q`;|zQ8$Osj zBN7Tj2C7#SAls*@T%t#8buVw2H=rLdArr63*G%qEPjZ-VYZL2@WuxeMBv+Mlv=IGP zw~@r=3cNLVq3~%W!rx~wud@K}uC|gp8%pI+H*XwBq=znub!zuQ6dr3PB?n5R9=(uD z9a&GW&stnS0S4$IQ`gc7wc|p#Vd*yXR(ta@v9N*bdL1pHEkw&Crc!ieTS2*<$p{eA9tq!1^rveQ>$`0JCN($ z4*CjN1Dx}z0Aq66$d$66GW<_31Rab-_NGh>dBR-XKN^aE^)m4u?uWsZn9bx)P7~xn z!`n!=s=wr)Jo?}kM8V0EoZV`^{(a5m#iUC<~Itk zB(;TX>R2p|&B>8nBd_-@6YsXLuHLP+sQfBqUzsmPwqf4QI@bMXk|WD$C13dZ*Ix02 zF*p)$w$Z;ilb*P$Ev0lG=j9VUaW#G`?(AU>`1k_+IN3r5HR9_Th55`Vz)vJd~7AX=M+oxAKsX27Kw_*L5zn3%Xf7=ye*0i?L;Y+djeelBJRh(Cx#(mnS_i)NLmmWjP z%6Z1^FDOGKt7i>^%Qr`K&BSp@cUMB;)F?dPb3Fj%6xF%*M)rwp>j2ssLd7P zN-kU3klyHp8F-XbfKfNvNzSBF(bJoGZAlbX6=%TyN&(E9v=nWl64^)I`9SL^*2Xii z+?oF_=T_24!RJ5?A9$^e!i10HQWH2|xum(IWR~zON#7{@VgEXFb|j4a^1#-zc~6;y zv2XA*Fbcgo^M2=Z(si(yX!eoQX{n3i0TXx$It6 zCfbJNh&M#iyP1if9}976a9g>1uUO(9d1FfMRxCY}ftj1h?b6R!_^?dY)aLci>sgRN?a{^c1t_qS#Y>oq?Q?0<=<^%fRNpot!TYjR$HuVS9*7|z6V0&AHgm~Try<#IP01T_o8wwjzh*_eY6awt1L$4L4t zTO2z|{~GxqtBM>1rdMEW|9F{0er@d3a10}N){K4h!{inZM<+<|T5CLf8UpOqBBpjO z?!=Hwnh`HH4d~-LNpD>ibEqqG&hI3>jW+RecROn%uS2kTEWLrB$&t-5;rp8y*&btq z8I42nrl$_Q>oDgxiT=1&39|034GLR_!nUCf5f%4PzZw0Kf0D-}r*oLEKeD41QR}mD zqbIq=AMvuRGxLsvLNU3C7BfP~<0R1McrjK!kbj&~D-^*XpLL$I?vv>stQjX~$Z5Q~ z9EyW{Kg$~A;#yx5jE4_M-wF2U6BmL(F7Xs`YRlJ^0n}LmV@q~5Ah56R%csmAs04#FmslQGY-;6n% zjTz+fu0D;I+!uE6=XHBDREti%Ifqr1KDeC;(t&aW*b;X7~BjI2n4> z7TME6;7ktXp-b+6{f1vW;w3G>7Du*+F$-IZTg!9!Of+HXxL66NcXHYJ5LDlxMMf*; zHPhc0G4+5f*=LKcrzISd{2Z4Zh?RtLJ9ymU{eD`DNtrpQF`7QmA8~StzQ3=$P7YqsGOvR7 zos$W_4a|d{Y7KeKTx*6d3#iw5sEdv$eHFc7oPV~yEXfyR~vgc z_UHY=zqiYr9Q;v9;h`BBFMIdf;`tQLf*<1hwmS!VzMC-9Cqc%OpS4X0L(G~am|y1S z=nC04cuGe0+jd?u$xxAJ4 zLh$g74rhku;9U;=o)&R3X{0^kl9*Rco^*&)4hFhbpx&YV(tHbfTcIcME3cC`*_gK1 z#0FO;@hclO$&=>Jq;L0?Ju*Lsp~RKG%cI#i>2AV) zz7K2X+M|kj7}k_%agUs7SB(i%_8gG5E9`J^Whm&UxsH;Pg3;SWN^lU2QC3*^H)0T$Ov7tq;=o}3By8>>F z;v`?}p`H?kx%~aSy15wGvEsk|u>T*P(c<};^l5|B-Qo`)bThuTOWPTv>NRBC#`KRp z%`^1Xj=QhA*~BfP`JQx}YJ1bGh3!xGS#&);NHyW8{h)>Ftf?rNK{V918E zsR^sn7hK)sz9zC|uVq=SGA#A)+&;Fvopx4l>%J#wP0#a{|4Os0wl1x5-jTB@ar*Rw z8~okJt{9nqH)-3M{wvbclU)z@G_BT3N;>PsXA@-(^9SB6N)(S%DKdR#io~_o$>{1y zVzE#sBex~Wy1Ge{Gllb*8m&0aN|J6{lVsT7B(eE?Kt^XJ%GvJ8ay%eKPXE$M7iKwi zeUu;zb|uM!I?3FFCrj5hT3N?B`LUFEW`8p`V@-o+|85aX@uj_C!`Y;8BhWSGe9Sqfg*> z0<%Dl+2ip|&W83P)2LSAMQ6_Pv!1bUDA{3y0}_5aA|qafltC)=D{w%@IA)Poc0iwS z2TbYci0btnVex=}N7D%O)Za6*`sPWgYFbqtI zfd6Rv8z-otyP(F5kMuMqhNB1neCJR#n!P8l$bHWo_9eQ!Qe*P1aC{F^W6Bj~m2kb8 zJ(wATtJK)T`uB9!=G_-Ee_{vw7Oejq_*0GNtS784WbY!9`O)b*Jj)>$eO-rTnL4cV zq_cwecW2f;URTf`JX(hk{v5eqkH$vUt4^?n??{g$>or~Yb*nime6<5T1wP3*&K}6+ z1N=JwWYlE6q|-Bg-;R3xn@iUNzxSlcdd|M-P`zg|itdqXd`%C}LmkTJ@wGgq51M^| zCwAWFz$_)cG*Q4JPXQMwaqXQ+w9kKw;YF#aJkZ( z2_?QQH_6~yl{lxVgnu?`^VO87^n?zWbR}-?WdGo6g&b?3M1z^EN$;kQpt=%Gd(n~b zf&K7-{_tggcSKkqaNG}#elnx*5&6YNzSz0V4~J8kso0UTj*tCN;Nu5Z71_o0zKBtf zZ*-?$#*Dc~nLe*q&JTB``>1CB&2Atqn-vQ{K!i+q{nfn25npL_imA^I!fkhfCil#^8YWQ z$G}{J%VeokTQxYTivBNikoSn3B>&EC6PP`?A)0$7GLHe#m~euOm74CEG4#1@ARooL ziDDRes^$iyHQ+oyd&(XDbC#cHK)f$&X$8#TtDS{=^danKy?nth16BrP!TT+JKZ~;P zl#JHvSy||Dg!S~1S(sp*g*+!mS>A z1W}x0Ja5DjM>+`T@zJ*^!jtAk*xWKA@<}1io~GOJR3UnHGh#Wv$Bjtl?iLvlLw@ma zMj^KEF=7M1$G+QSw%DhUkwzr4hrcDpUe=y=5;O7+s}4F!%P1$Y*kmh1^v?3R3VFj0 zR-(UeBO7GNbKDU;M z1@>Z>>L|_WXxwbkLH>AZBS}M4@~W4OM6~K4%9b6Z(V_P8YmQ1T9(IyLN##y#LYzu}%N@E-1Hu$2y;>m--4*CF zfzF~+be~3;WXS_^8kyy?V?R9*n@zH{A!mZy(Xli{fgMpwSezs0QoUSyd67fjOcxaI zuOAx~=#@rpIoJ%{Ci!7HbGWvU>z&t+Ua0T@bX!4=qOw2s_3%gW>HyfkWtN!I4^>&C zG^W$Tae_SJEMH{(K^Mn9Us#_Cz=#!oNIm0+w?F-0-Iw2^x*vYFW}eoXKn!O-^*_9) zrsevfRu_Nf+4&)(W&qw*XWl!1&-m4!E**dL<@b*0%KNL3jKZxbtPN$)(u{0kPYuGp zN7G%Wfx~WQqn1RWnJF4x?eb=f<4AxbfEIj zt$j&mCqjcIuJo$j;XTKn7n6O+$cx6g_tDs;AUD}SgLCd0l(f`f;CE(x1ZlAQ8r@eF z%oqtYVAaF_WKkHHw?HQ;xnI}&beZ+ef^s5RUmf#R!ZPVd;r-=jU_Lb&;DrX%xypJU zzxF-vL7xYlL7rv6xw!wiO+7URys1gAX|Mq!i`if7&i`kY#hMCp;e>V6_T(?v>zgn& z3p1bbp5%QUXf!gj(TFjAMX+@$Lf5WESjy}D&Gkauo<>%r8?%haXDn-P#LM@EXl}`S zi5$|a3G_J5=DqltGpwvz{e7Uh1dwa0+^7gK{QD=D@cy!AFEp=FdU~O*=ZvlE(!Fl4NdKiubc+l-mF^a0 zm#)}dE92;aSLx*u$?3<9zthV$Lr+JsyeAvBSlob66HC6y`q&)7Od1tzo-=1uvsUG zkF-*wp;q=rrpoS4NfP!?l6ap?mSq)M=09-`t-4k=WoqT)Z~D3llErPiR@}Gg#Zi+W zVPqc%{iBx_+frl==VYEKb<$u7(OiYrrd#RU^WC?=z+GD{{d+hjW zj{qMPO8%f%+m3dYZz>egAvMz35v$**u;wKF-4E;#y_aXS>g>;qvS&}h0R>_7I?iyw zkP#}FLjRL_%Gtb$PAD~U-*{4mmL(3D)5sCmrqlKPT7}$n2c&Fw#KeEu6*<9q%qR9( zTjYS=TO7$|sW8|>jV8w;aNV4HGjfIxKZL{n5PLwo)d-GOVM}Ll?Lh7xexk_iioOgZfK{J^jf%^7qE5$>~(+@cfA$2ihj1=TRM$tY=t;>F}cpvqQOW zJa&=U(^d3%%C9?fiW$}|nLmA%-tR;`>Llt=*_!=Y{{7eZwMzE6#@Oo-xs`iAr(EWw z@Z8V6;I!wtsQo$@Gn&)2UBsCd_Hogi^Du*Q!3P>HIWQ;nS}yXwat@{e`*r8&R!rbb z?4Rt{jm*W!K6!Mdkx@LxzS%$YR}IKT)3%%~Wl!(?C^{Ms<)M`#5B1(N$2ubygEGlM z@(e!wIvs9P{vXd+Mi$QJcnA6P7x#fTo#jlblbjl6BL%)@SW|^8h`ADHdnu4nti(Dy zC9{9HUwP~g&pbc)f1w*8oIb)+fiTObTe>(JE5qs4tF;Zwi}>rEWEvYY8~9Kbsw8J2 zzmow2%*ljw$U?U21L_ScLRyRw$2^MgGWY{r_b_|0uS)I)+DiAA^b^NA%ds0ya&CZ= zyl8KR@iWNJx32_?MP}$UjdLtlD&$wy0JPKlfem-m&i04n;XrJmlOx%hzUnXBPbs5e z@67!W+49cZH%;1RK!3|DeBmC&a(fn9+#}2QE)yR&(fjN}W{*rrtwiQKzbrysvIZ-Q zRPs>QLC()|lmW%I;_;a-e-h{f4$vT6u?=4$_^ck!XZ;Uy>wG5f<@5bm6rI;w zIX^*We9?p=Sl=*WA!jjiFVRbFYbURIJB!P|9c9B3l{8tek_WkTH+%B$fAd?u%~qoO zCMDvRD{*gKg$(LL4;h`6oelnYZQ+l{+?TehABc(kY}!oRhQ2GANBNj}NQ>!0yb+Cy zTu-XUW+CLR0pk-m!$M}}papph@-mmY7h%E|KD+sx&doQ%u743$P39gY+*$fvaFFAj zne#k_udA=4jOMjcbGu1Sk!c*fS&7$2&0x=KsRv)jn`Qo3;ulD_IOh@4{BX`b5Q~GN zk;u<0$RZk!adaK;j)r=+22&n#jpABXZ+I4t-pRzB6a%I<%7W{9ax$06rg(FmNiuTg zjk(;#TvJ-P@Z94fVIRpAC2-$VrK2R7yU3|zC0xifzJB_fXL<$vHkrZqk^<*mkv%=+ zha3sS^lSw!F{4%BKM#@lBK>%FXK3WetgnFiFl-wfcyNtj!vjoIB}8Ec+>CoR+=sEr=l zM|p^T!t-PGeB9;vvX0k%+~PA~$oj`+6>BZx;P8w$D z#&T&Es4`9=+78Q4Uag#NFatJsG)u zTiMGeZ{Wl%$o6Kb@^7CMS+!4}$@Bh9vU#jId-5FJ<}lx@ ze>n^IK93GM@(s+pUeDJNepBJ0pqrp6U)LUfUQ@>Dq`zm1SOn_D+&e{1&eKY7|uM*E=y6DujACF|J3HfF!TU@nv#s^6ZG`!>#_Zl4qKb* zAzTyIWpK_hlkKryUF~JSq_{(U|ouP5ex1^lph?> z^$1y%NfB_ih``@n)G+rVFGEITQ9nJ7-`8VL3i&1l*X75|P*>_Pi|@yMer7)x(aU&^ zF5y2pS6w$Bns;9M`IBss~nan792>?|jT zk~iO|MC=a*)MX~g@mC^xsRE8$n5S^e4|!Uixu=qko6DSpXZ{%0n~dHv4e~2#@T;x{ zb?0%m&zcFMDPC>BhGVA8`_Z1LjKz2S0~X0 zSxYZJ2N}?$lPvY=B#k$!Sjjab@fgqIA2R9kqO0Aa2tC@; z&qyB4$CB%ou?VY&7NNI)2eF9jEGgGJh+RYG0#xcCetbTDBP)2N1z!hiA_XZ5oGN6U z#ZrN(JgfQmaDD$b0P8!`Wmzi#Q@Gyy@!a!ZEYC!&AG~(=Ip8vU~DtSgZSL`Is zGM!{uRR?;YoaFDHPI9=LO0q6h$jH_TOnj_B)0gBJ+bYm+iAlcZV++K?Sghukr`_l*G3h2&0;EOFaGzeC1!)2az4}8_&c~cDxvw7Cd;yEyl z{Ng~?aJU!R-Gnul>Ri(@IETjdE1BoNX?$%PcaqHwF2ejl2gPY(vRu_ANt1^M<#mlz z@nt?yPj3fw*-nog=iXxy?BTyig&x<)rFpPlcwLQuYcl8l4cCe3YR<)}5!*W%Q)VUO zW_vxVUeu$_U_EyH!`Yz~`S|^J9@dS^$L$4qSnwqeiDr2)dr7XF&zzX63XkW`^a{UF zc$~eh@R+RU^LaC8#CSfs8?Tp@ti{i7d{B1t`LidOe)_IX2#zC9UDpXOhdN@P4IRGy z>4>}>j-@Nr`0<|4X6Fb@c*S}5_w@PX>oCBRvjJyx2r%g2v7gVKF7zLs%EKqtavKKb zL34e=_;iQsnnLC#=v0*GZ_yx(( z*pl(Sk&DH#TqjC%(XSdgc+Nq2*3LtJx+-n>TJHAa^SOo6L;sWP-ZO+#@`9@kg#+1y=^FBh1DG=Oejo@1tLC*K*Ik0Hlcqdu93O1ty0l+WV>t+}43 zDm?0wV@xaJtO7qj?J=!XFu!2y{RDCNMo&XTs_a^l-JMr4#`ECBTJZ##KheOI$#zad{X$nXcobJm1w}=HUHY&W`3GX{OTS*f#o8BI&H6+tZG(X%RoO|2tQ9 z-m{fFv?h16*9W@q}H#oLrwniV`wI>2a}8OHW$UtUvj<^bBY&7p~E9`YFY1* zw2wU9;9_}xeK;14kHVt*oU0-iliItD^k%;89_A)rPKd;VXBjxWuMkm%ZKTdblVlHP zPIN^iToeX4&nU#8ZPs$nuS9$(Ey$q8e~G_%N!numU1q=RQfmf0!Bn(R&hE; zmc*Mn%7qve%v{~#U-F#)t}y<)EE?0l#;^b3+fpj}m&vJ? z%#E!b2{V5Ei?~8mYSC8uH7S$SZoXLfFbbC%Wddo1nC)OC%bAbd!GYeojZugiO)nmK zw-0^WNnrb*l4s?O-33ulmoRrp$GPEl=FsH2NS>EH~ks?Y1n-$KS+E0(W4 zeG%|63PXiiOlJ#l;{$z;_bQ|yfnGWCQ=48hr<;6M#}jQOGyfu|^q2 zj;~r9v7Gu#T!Ot&p^rq`sSH$W#+hk)6;E>CGsna{<)8Ez#?q^}p#YyAScxBf6pN$1 z*`H*N!Vm-I-7bW4WgGcoS1MzJd{8qc3fm56Ah|AU_9{!}4Y8hG?2XzNqA<8aCJe0m z_qb#yRVSCok5F&?%ll{=d0r2HdP^s@5!aA1aVB4Om3ht2^cko%s{m1}TgyX>V%bLy z*Pr#@wM#QG!iCNQk2a#PDwRj)ePA^|5*PZCALR9~-qlpJXN#q3Fmdo~q zJ{V7jh0nVTEb7Voh&<*~t1{V?47llqe*AY0;(gbU_v6+9?WEz-U!pngg?oYA368#gc62i@6fTT6`v& z@cqe)w2(jlDi$9*Z=Aod6}`@7Ku^whXE6IHr}#YS?Sq7VQLq`Cfo0BrA58iR!60M&!_Mc+G&mmW7ycv6Yn7E)%O2eBNH7w~;*Z zEOOKBUenjv^QQzyd7|IKNQA7&K%0~TlniVyr&|A(lV;?^`8<5hGs5UPMy$MSA=FA>L@YAPUbyGca^4-_J%?(j&E4mbCI@?nx9~j=cVBl8+wWPX0Jm zEMOWrr*DaN8S>Oqif$L6BK9?#LBHPqf`i%J{$ESK?k9QOj-ROxwQGlsGV`Tar z8(e-Lg24J(yzarw8FEYucEvEy$PRNxgu<-_-9MFb;j+Vo^q5#dku9^QLy^6o9=Fcy zZAY81{z{_UVjgH$yHGq|L_gP=90WyIpzp7Jbh_IjjI-}~oydRrX5+gn^P{u&%Z{41 zc+;HzzOh;?ADM%%Jxwq)jFB7#lpvZ8hPXxTV75>D^eV9A^)YFZ9G&Xz?U2 z8?I|jSZo(7eUfa^u4yRh*^rBwk&RBjD^TV8ez||#7K{Gi>m08|#E2Z2tW4K^p25P|Ja~pRT!oQYq8lxPvUVClv@%df1Cp>`1&s;Yhkiy zKJRQ3ec|M@W|DVvWBvP>7L}aoI;x@Y__d9^+jQo%k}Gt1!hGa&Ik5S}oYr?SvgmKt z^Ir$!b6+hs?aD!ybtZJLaX`xY*&=gJC>&>M(VXvFoEhg_{-z($oIbuZ@?0ymm>y=;w`8`~^Fl=R#+-XDUd{M^f|`T15- zc+4fwc<&TN zF{D$Xq&>95@qTJFHRpA8AP4pICS05nD`|xw_>z7I5h{J9^5nDOq8s+_Sp43 z6wQ6L&~GQ-x4MEXK#a8BYLAlNOW>r?VRSdv>Z>wG_)ff39qYiHw{Z6Vv?yE1S)Vs1 z=z1TJ$!~1Yk-XlYWm+`kbw1|431{xdOYs>Sj3cjCi|_xA*lcuYqwuKwGeNGGS)tOx zFnk)W`!8?%XHyeCMaPS})E4W>sXa?$F7tpKyxGe8>u{Wm>0pa()?s*dPm6uz1alr% zVB?$vvh$=JM%D~P#Fr#=_?iPvV|p9=B*;x(Z}sQXXZMrYqEEA-nOT7omhn>kfHgd7 zgre_iE&fQz#>`|B1`dpuZ#UXwem-;67w9mxe=c_1rMI+woE+_GhmYiZ&7H|D=Fq1} z|J~Q;^c!Z_qAIhv*`D5+~93cQ{4{&9KD?a)JTmK;7w2O#in6t*~FFc-mouZz%4^lB+$Ci%py8 zOPw4q#?$250{D6TN<#U*Y?%F`=dn|QbT+fa(25YaR@cIH)c<^uS>I#i{!BY~`-Pwr zpEIu(vG-C_;Sqd2MwTX7qjXXzs`9#8`&SOu7gs>HD^@C9vqjyxAsAJIvv3Axug+wy z_tFG;>T8WTe4bcV=j-pyY}BW`Urxoy=QKNHFju;BIdi>vogb{F@YwIo8R?bQ%&rN= zxOe2KopUgDe+3#^BuLO&8vf!DjJ888`OO!B zIxMWlK9f0p_1ak3pKk*X^I)u=OFlF>2dRAitUAFw^mH4nTojHVOLCEebMU^M!oxC( z&zUpKa9bZnCR&S$d_6mQIw&u!4i1*TQ#74zofym6ZQj$v2RvNq+rbzWqiUUE^NK7ZcXv!fE@Mdgw#;dJe6*p(<#vUKu`?|JA0 zt@OXftU%`M9Nfz~dkd{p<+J5bZ+Zj{B+CWXbzSf3WZFN;;@V3q({JizZj%&w(wQ}c z>&bG{Hc7fhCrUqaW;#vaoa>4N`4q2{R9@Gc$WC5en<&#VQe~u9swg?`DvCI{SRox0s62VA04xh@lM`^jWYq43tD)doEr z>*_fNp~H>JdemqAtb5~RT%SR|&U!i6J<8x>cGow?JF^gZn$${%#Up-#kW6z-x z|LiUDi+l!e4Ax;6``M>i^J>mIPI#^!D%Rf2*XdBNrXKx2>F_N_hv6FLU+^__)#~uX zH4mws^N{;1AJme=F+o#F&7EXSeLiu9P&)EiSy}WNMvTmH*$#jJgo7~ zML26zHw?L`@gWztZ1NG^IG@?}tmm`m-PFVx3_~8?vSu@VYaV;C%$Qc?V(7_S{MeI+ z0`|WrHOWWcZg~hR$weCLOB*LL`)!$vczSh^CWQ_%Xp6O!SGSXPSDZyR&{^IewwH`v zE)sjtN{+p@5!>sWm;Y!Z!;%~X8Ifd08je$d|-SD?TM8`h2^%rMMKi8Rh3S(LGcJE%g6 z)yzHgrQaY*fn)r$dkrReTv{##MJCaBv1c)}LIyjVq__$*t0$IAj~E5dzDiu=-%+_# zfoVOI=seXVw^Mwfb@D;~;mp|>Qs+QS-bI#i5wkb;2IBcT zI*ls)FuJ8bG~4`9y4(l*Hqj9=(;t=I_+w0@AJ(wfJ&*kXGxl}Mu190xDh;|^j7Iw> ztdHL%r?`PRxl_q8zGbdaWHg4Ec- zANFaGH?!gJmpK0z zNQN=IPZrFt8t@|BfW}3veO1cD?Y0J3tTAx!O-GVvCJq#4(cwiOq=~!(zfVGCdL9i1 zD8{mvO%}5GNcNAd*h8OX#5~sg>rNz#=*QkZnDKXfF8LuMif`D z-?Y|D|~?sx@IgyBQrKi5;Z-4F{Q3&0a<(rLDL% z`z>F(nW6O9GOSSc-vL>jEGiSeL`#uGlwNPN4nG$xBDrDGm1yT}BQqo3&8+%PM zW4Iao9V+By7X|k3Rp9V$vJfZ8JG!$cNJb)=_nl|90u5HNmy)W$uSq6R%`205Ka)Hf zYm#q0$wWHR?RdL_xsK&B_+6RYX6AZ9JwJ@h_r=5iL)u%nMcKV!+XHrY5Q>P@5O#x} z2X^1Y0JhlOEopZFV`8Ah%m8*X45+u=l-&h`o#ed7{d=}|dp^MPhZ~46jMvOs*IMh` z&;3}dLN|IEU)J|Wlj`IWhp8~JfS*L}d~M>-937-aR6k}_&m!+opZU{UqOqoPG&%*UG4Bq0bH|V~ z9u|$lDP(+#nDxQmSG9^7-7UzFsOV;N;>Q6Q^qyVB_V>)H@=so+Wb(72csg z@qRk))nPU(YjVpX)6k(~I=08Bqc!VuBbKLQU=5x_#q(^e9rMC$GZ2};+>HffkdKiq zCf|7b7kLzpso?o^TD4Ed!p`K1_`MINlb_i{W|B48+8n2US7cyCB)zK-@-c|-{rdKw zVBWp}W4(-6evi59W=5zt^L#a;0OQ<@@a|rK9#sl3fa5Irni2Xqj-51qoKt`@%L3H$ z;2(~yJ-J2%?aRmD+jO#=W*ze#&j`EdD}KGt2%ZBu z(777GT>0*|yV$tBx=@h)yzA@=yY!LMPU*Y#i}nmnov3de;-h~&=}_te+hkAI4l2)@ zVGB~LG>h^mdix@^-KkU$&!$y9R{grHuit!{=ak`mmS2Q(PVW!d2Tm zr#@ibvq!SnE!WAYZCVMsnk0)7H8MXoDzWa03o4Q`{J5K$&)?`*v~$5?_GzBJ zt;BDg3j*fTzs&mzYyxPZgXCC`zxMnokALphHtGO;5HBE>4YqgmAj}~b<4YRq(G?Hzsr%Zx*E%vs! z>(Ga5L&bjbkRCc*iqavay$)Awbo9{j9Et0|YUa6kJ}et^N9JH?a1PR^WuZjP-rHh& zvRJPidz<^Qw)C1!$iW)_Y{Y1o1-g?xsZH1?!*ykkLaz6Q(bGsSX8T3D(CYGhFp}#= zaznpz$vKA5cf&fYjVcFT54h*!f*bf4PD z*!nKgLAjjT)SPw5*#?YruS7O*$DydM5gk$9_?OXwC@-IiFPJ z91{QCi0ZS9XrgW>JyyENd>0p~RohJ#opzPQjp#>=;aYFMImVI)DSy}u;hqYN)sRP9 z>5q1H{`jT{q*FNnUA_G=+`}JF$e(>nqEC-=b;c-iD(jgU6|aWp-gKxqe`aT#T3g`_o;@f7rr>}D^=5;#VkJ*!n zE#=fQSLqhwBx@@&FMMDdNqJvNCp7zh7SY)>)eO^{nDgx34C6H_U~nKKF6oOr?T3a{ z{1KAui)UeK#PRpL^4b(Bcc8`w`mXLqq1|`#f_y%`r)5Cr&2`r;KEEHl2bmSXZX#Wp zbLh`aB!fDZb2YEg&EZZm^+h{Lhj!1v4^AnFVWx-Q~;V{SF1n zP%6ov*^kiHAOB{maI1bG2BrHWF@t~Sn$+@ZG)DH|y|)GX2>AEUyU7&&HDK^H0}}Y& zSvfER^WS8k?^}M}`V)>UDnK}`?^Kpbd zk99_+$QjnohpLk09eW!8lrf8;whO**C3BJQijiMk@u@F+3j4U=M@~3yB{1_PCLG3v z5oq{4oLnmV0N1m2&bcRr^U7I%zSWL<*uhDt#C_k&Q5^IAb8%`Wb17$V&e)xUf8)qI zkSDm=jgH2z3a@YELhA8rk>v5C@6#=O>zK4@sFRM}lI7)Pogjd{kK`}5dXkIls>H)x zWG~9oMXYC@eC6=6eD!qT%oWoNim`$m}JnpG&59BpdIg-o%q~F@&1%XCjT3~ z!Q>t?dGB&B3&m$%pJ@-tTMQ)A-ZKfIw{@sv(BbiLDfq#D0kR-U-d`^c;=S(!J;WdBw&MLLv504yN_sBd z(Ql>AK||hmCi2=ebmcv0RW{;+6<#l%E4=)(6kd7P$fxkEeKC2$qJdhOS20Q4#~hVq zlaGkiDV_X0oG9z7lO?L+3j0gU?Bw}Vw};FS<@M=2fG%bCaM+#Ty?JsN9tALa77>VU zLU(3EEdqH)v(hyQmaB9qc*OkIOSxDufqeeD94t!W{Y{^Pm+!ODXtKg<+#vEzWJ1>4 zntA#4W$rY2%Wd@LejaQuTi3UhNn_mPhSEizJW|SYy65+;Hpe~oU_IvjVtgM3ylR%p ztT@g!LH>we7>HpO{%EwE{MTfEICkMW|6Vi#Ox#uN-p>JlS){y|TlM z)?)X>Rh%u|IjOioys<5RjXrqu{QUTFX- z-}A%D@&4%e$`4KEvNwxo2V=ErW@qg{`**y*b3R--f%75fzz450F#8Fek%Q@9&Q6EL zsRA6W#d)yBf4u?BNZ?+&_#E?$qn*W`{NlnX?y}>nv$VBiPi)Ul@(5-as4A67;R>8? zXp)k}W~lO-ds)9g?BJQo===Vd8WVu33;p2Nk@IwUHOj2j__CCHuSJ}f`|ZG|Z&9%K zvWFQ{8}m%xZapUpXEL;=9*4XF}s|5POg9IRpVKZzY4h> z)i_#*+~5c98HdyJ8OM7o_nS{k3{Z|_7B^orhr{fh;CiFp_cY|+Ex>Un@|D~hy;#b7 zDbF%4j$}W_J{R#YqZ4{*Ysq`tT&_2El}A1<5-`&Yu9eH-!4q@5sH?!$Dhj+gSth*) z@a#$F4|}^nwCbUPVU3FU&jGOZj%MF2`|o(2QrR2Of%mV;*n#jX+#~8UFd;SroxC&f zF(m`NUNdu&uhqqMbRDaiThW&Hu2sf=L-FBkg!8!^I?q0FuBV@M&B5_nxtK9j;nmqv z;WgJ+;bqDB(7gw1=AkNMv#D_a$WHt7_P33;cDIDorBCvBlug~Rh{GJ#NS(7sJYL~=*09%Du*#?D|{xxgz z-xOZMxkoOJ(@1lpR&MgzY+kLEbIUYRvYR!DJuX=N-37TXxzC*ELYE+2mVCc7;e8@u zM;Jc1MPP&>9JRkPgV3Jm_SJOQ-z*77lXX~AJqfdRai7*C2eCXKzx0dzLVcD$Dzq7!;CYlM71KPLk_yB(j)ScO*xKmY%EMvuwOWEXiW z4S71Rn~~@}!hq_N^I>LeBKwwc#We4v*+Bv#^zI1!YoUyD!fZqVV%`8V2g}Q0u<6;Czt`X;1Et+|9z9Y3TXw zBl^v-kV|j=NXaN~RDH=DVe)rQEAmkNfsIrjQ!F;Kym{}BLM%C^0ewEA`6oWlgd$l@ zzU=CRD3rEi{%qfTEL+q>HZLud#(CZt{W=N<$EV@Y;g9&YcN0k*TOy+;`vG5~cz(vL zk;8fHW44ry)eEHtIiLzUdg68(xE9RE^%!fh*8CN>LO+;gk{`UsoZNGHI6JU~_;xFj z?ujZm|A@l%)6Dh0%G{94*FM4j~b*n>8&_EAnGaDH;wn$varGESxg%2kT zxc-!$z8=ogQiB)@56Aq5M6OO3`pTwg_@|5E0;jL1h|clrva7fI+?Uo5P{{Ni&4 zyt86n_S)u>FtbR~zxkqc1G&puysvfVy|m0io{_`dK@PED0Qs+q2Chfh@0?~W4|oQx z^7lcqo_SF3(s&K%yL?brM&2tDpL#wh-5iO;9M%r#10A8NFYkK%m6bfN?Ny#U?5T8I zYoCYJ5e+4CCG)u3_@U1$=58NPLvuqOOh21T-4!LWqNfim?nS{f#sG=T$0+*m4)5pd zYwv^d7LnMUuE*--`B;C_PC9y)$fMGKaN;n%kRTs7^&>s|wo+>X{iOch%ycGi`z;O0 zw)q%QkKWSm#nLF*2cw#mJ;yxD z=UJMC)b%ct!lmR)yVGfLihN}b^UXOf+P(iPrz`s6C;2t&Yy-J?W>^F@5@+usc~{>L zo(}YeKTE^tMR}0PO=Sb?an&7t@ppVQLWLZ3MXrq}Hxy&TQt3fn(wX_l-}t&49rM{c z&{ziP3Pt7ai$JbZKD=O#whuYta7)3IBDrvcIZS8Bv62s+Ta$i3dIqnJ`Ym}sy^-EF z8eZg-Q^|2Jf80cN-TF&L#T!-)qEMxOItnJ`W4^DAG*06D$@lZLJyGy)Yry&6VzAnv=autuoLBu#hQxyIoU)lNIM_663l$BA15_OutH#Z7)`OIyvmXCu+ zT8MkQB59P#|1amOn|;ZFUd%`B06RHV@SAfY-w)#=abdgx1#9#0rkACd_LRwuFW$J6 z7KxZ(1MfBTC$?)L(`y&W=7XHi2S;I4fdLku^H4OVv7FdZBs0tVAjgWYS8oHF?jq+t z+lF&n)ECH(^B0L-Oml1D%SYn9x>(Wuuu}YB1q-(E*7b#&c%+)IR-A z#DKP0nC@Z1ME`g?haC~~Efl{jG#Hbag-zxPud5g0q&Aw7(&|Cbx8^x0j4Q*itB2)TReB5?hXO0f50Vd! zIaY?6iw?-|drpYA4a27%8vG`YwuC%ah1G||u+tHj>V;y<2@QVm-1^{7@=6us=~3nX zYh);HNAUGMMqg7oh1bYmv2wkfBiarK#rUTh`i016IVrqs*2c-Iy3BSO913?nPksMv zI*r(OTP|J}+-Dy51p4Ew$!VU=f?s{^0s6+Rd2F_=W?Q-TacjxO^g*nu#$l0Z7u$%m* zntW(m=9oLUJ7etj5NH=C!m5<-p8|eAbCaieI3kSP=(@ieoLi8^GiHTX*D0}b`jR6K z_yyC=pg~9Sq$NQn6Z8+D*D~RN3~o)QSZWwz$%`eEQ@cE$ zx#5H8I2&n?Y06+MDo4NM)-3e!p;yijCqB%?nmL&~+VVuSh{?qL-h7^l1o;-`jFzi; zwiKF(nOm~3W|Rqy+8&bE-yP7ma2a+D(%}5$Y>dh_;ZM(4d34Vn*XdjQ<;i@~{^Z~q zD!j4}kW+h2zAru)#n%&2I-B|FCKDV69+p)x_E>)+6pbp7m*M!WpJGDGLmIiv|F1SP z7$??iu;d~+TyGOBYH20yIdj;D2BYW~$JfU!Slutfr6&i)aL^H1_kuCaQ;V&MnOI3) z&+O?T>GsVLrad8OI7EvYO|$U#dnvwqCrAf!iwj*s@Qv4bTTm9_N7KhQE>>=nKegBp zf~DUR@gO-1ip3_xlh^B4n|ZO_L&@zV;#cD=7>s2YZ5=PwD?4N8xG=J=TIBDizwciY z4*%LOW&FJby+YxaszvX)%#ojFf>rWCxn7HIkLjV9mO!rXStffsO*m*BCy6tdM_e-m zU&(dW^&q2D)x`V@t(;D9!qNVrsGUK+lJnTCg(h50jg_nR%s5LAMaMx}OmX7-nY>VvU-RMKS6^g)H8a&*a1%L9+A0x?J_i) z&nyGZOAaSYXgVWK#&|j6o@WSD++Pfu#X3?V^JG@XNif0b9JrWtZ|N~ z<>8_F+mFpWl2^L$)|9O|E{@<7D^>tI4cxGi}dk$_=&SPZUE04nL9jPAYt8`oK zT27zvs-5TZz+GM43bm<2lB#-cHM~vzJ9U9RA)t}xd|3|Np7N_DR?txBD1SZPZ&CIo^7ccu~>m+goSx;sTeTrsX;_gxTFow14IZ0wu zGf6Cl$IG$DTImx*=OXhIs--1KC^N%5)r*s_RkYH&k%s4m8rfKxJ+76tvM^99Gh#K; zGDsuGPbA5f1g&g1mMAXE;^j^St=P6pl8j7^Y@W{E_D{~tO>sdJa*OrZkAKyR{rBr# zkj}mLmnEzvkD*J!$_?coDe-i&8|-XS;C$0+f2Gg-u5%#psML=?xakJ1GW zt(o0)TnRfD@`{t4k>skRv(pt;^^|0Nlu&SNeyqzq{R=XUN;ecJmFOm}FiQ_djSKYW z{2PYqDdDKf+Vj^XVfZ^J9AjpO!{JFdtnP(jYQqRDUmK2Us&FKC3x`Kw7@q771Ddi& z{|$Wsox&mW!qER79Xrc-uKgqoy>F9Ubfw?megqyK=b1`KDECpURZA%1U-At6Rv0`R z@f>_*IQ|~v&)KoYvxx3t)~9Ro3_P+5dr5Q2AdaSQN5eHu4>}mnYO$#=GoJc0n~P`X z^(}Zt#Pvx3Hmq@6X5INGzsI0uEnSD|adi0{WHw+HYY@wM&bE{8g89sd+NQ-3GaY=& zSl3>|IycYcezN{ONR@=wQCe7w4(s_d4g+*(xHkvO`sZNI{%knCqI=OU2NPLuK7K0) zT?)zY^L%Uu|LsL~Hp<DWXL38%(jy%Ua>OAHT+VFg5IcwgVoaId8 z7IKC@m%BUMB=(?-#N|55!AMt$Z_`nFpK2iuVp_?-vvkV6Xeo^%Tg!yu_OfoOgR~gt zB6Ci+m5c0E?`-Zacjq>jRyJ-j=#ah4o@y_Bf3au$gsZ$OD#Tfyoqih8>ZOGJO>9E`-VBx3zagw3EeST1>D(tUvnW{DWlC0>7YPsC2I}$S&JQ` zK*)5H9DPO)&}wE27MtOG0|m1mOJ(phlbF*3ciLWo#9yUiWdG?_{@a9qm{09Zw|zqe z%1<;&6R^ksAzeZWGyIG+$Aozb#N^Wv)1yS9hMHvc7UmT$qC;*^sVEnyuEnX{V;Q?3T=C;kUg7uLzRc3 zIK>bDcJ)VX7rGvKu086P9|k6JZ|~1~_HsXX-ws6T7k?ax2e3^u0xMkNlhG(<@k?=Q)0D z?&TD3xZiz2zv3h^QX|y#_ebM-fAR#{Xhd16(P@|(!o5p&1-cif(P3YXE`zCb-1Biq zyQ^`Fwd_Isvwn^m<}1lH)~7c}rN-`@D8xNXN4X%@{dr!}D}-*vII;-O$X)#;mspid z0RMgCi*)RKZonYcd`8*uTzpgpwujUGb|D=XSmU^vl@8;PbTkSjJMh|o$+I$$&+q$| z!QS0W12eH%2YzWll@Bw{>)V$xlcFZ)0hJG1u+*_V`NVOJ#g2^ zUfrSB=N7$k4UMRGg}H!}3gE`aue#BQ39ad8s$M{@*oZJCAD>R5mD`Ls8bo*8XZn(+ zGSh1Sb13J#%d!p*a`Kvkv>DMtEbSd-SZ#N?VCEowPV)V~#!ZIbcb9}%XZiY;u7wNq z7cFv?F3J|tu(_RFZQ4e9Pj!<8{hZ|l$CP1~oxFaol&W2vr9(|;ahPi_A7?0Kev$L=}SLUQw3cb3Jf1pA{Ip) z6Dv(Jb8o3kcPoeO26GH#9qoQU1=cK~YimKNtfY&v*FAC&niBcYg*ojH6xbG3Dsy_% zx7dU($9U#@)+m$J)k`HhvW)%F^r~{4MUrFOYDGTsrUDC2mP-9@3M}qzhT50SFzI5M zR3+~_F;|7%WK5nPQNiQ03Qa38OPZW-UHD4XL??*<(v`&HQgNQIr10+GYQ?uT&! zzBp_2M*_!W(18HdT;hvCgH+5C-GQI0I8F@odc0x2dJ8prsoBSwL1$^tXdH85?&cWg z%k|+HSf^(8E3-HG^&r;q?rvgkSFjq(`||4?Hzzui8SbsdOfUM!mXJSgy926L>i^aH zY}V2<#X4mF+G>2_`E%qDj=33X%nzn-^$>j~f#g~^2CF2Ji7=33Nio21Ivr!%vmd!@ z1}3>>pud)^@ZNNUm8Rol_Y5@mrHdtuW05tw4F3$&H>Vr5)PR?J$W&Y*<5)2R>Mi78 zhNfeXDFatob4`!o82yxn!?QDxXG@<8$LOLW^2DrRt!}63=~%< zM>vx??O*ay`8hqOkBxYCm#lB55zWm$A=sAgQvOl@B`-{Ohu0V8v%WE6D%rz~cVvFa zGX`20U|N6?(I;73Eihu#KzdPGJ1oz!7qr%hv48S$ZMPBUjr6hgp#OvCTz^vNg&b)_ zV;_1SryEgloD6aT*_6RgJk))!>CHw?*N?mI=9zf6xqh_SmefftKXp!<)HC&NVI}?T zRv$gRsy_2@+g!`@Lv9;=pTt3)i~i=O-b?J_@gh0hb6%rWo|&o^`q1sc`U?ZDd!+5@ zkk)JAVb2i7L(lp@CV4jf)+lYV$7OxrXRr1Br=+I_S8tdWS6R`mSz8zVz*Za2+n(8? zKjPOQZPRRhs)Zp@mgI8pzV4{ZpG`&)%$SbQ$di*?yS3Cvvz0nwAD`q}GY|5HPO3hp zr(?55#?RA;{S0!50~2N4jU=(uYUTE=MA`j5QFh!k$+$487>MxWlZ;Pf9#{ro@Qx%*wj2 zL}TuUD^796f|{;SDqIoT(FF++E_mjrL>TLAJJ-1IUO_ki6D6}3*b~EEmtzf`F<=Mt z;fQ$8z35?bB1ln3`+Qa^aY>iH}(!3HNxuHGHuSl|G5Z#KQRe2* zsYkYv_0y!6>~UE}ZgDf$f?LVEaQ!&*64#F8fqMC5;M z!i>r#n@KnKu5A2XLI-#ezt6~Zr%w*^q3H?vK-V{WYSb0zz~Q=bku%qhSN|{1cz>Of zT**;N#{#9?%yf|c1+8V_eizB_W`?IX&9Qlvf_V#Ei#eJ>ZBSqb=ibb_Dp=kLz||bC zp%$|*V~q+K$LROF#yK!5ntAbDPjKDxAv79Wd9VMqH62-;lfpPxZSKS@NT+nPa^hUW zb9C3?biBs#p4`QV49*wB>1>KyEhWI)MLz#>laKpaN!>PNF3ylgdqv(p#|$Tn znYY-8a7cKdQd71f8dGO;9BfKWl(YU6yID0B3o}R`%XeEV?ZREvC zdL#4A@TH3xmdr89nQ81Ja5aOwy*WIu(mlxQV@F=bdQc#qr3B*Mk3ekgxC2(_=m7SK zM&52ZlYT{Gur3;j-^mrkq+==P;nk~{i}{TAf!XPp;bp|kLv%$)v&Z6M0cLQ0v%!`w zTU`tJe#A{C%xWchciT#hg3A5*9fxuFV$rFc&`}F9B!_;%&s%9^I|$Q!ht`$XpyOz)QL{-OrPCILp7&Mg3`ji*)bmE~g7yi?Y;FieJ0Rr^f6p>QoNBcbK84 zg&Drzq5t`V8S2u5SZRw2B{%)aSqCCvgFnuX48)O%bV#sn=NuW0hUa0#M5D;5d|Y0Dfwy=c(G;Na#P+f|z9n$o|6eE@-jK1@>Odqx_~snc5j6#?omu zDI8Bc$)g2?zI)_gxo`a^2#ll zf72|7KTD?Ipu(&7BYLeylWWXYcvalSe9W;&q{WUTDdzpG`x>3hNlX!|={k8hm06um zuBcYq4Gwi%qQ-3{j`_O4+AIRjY2hg4JZm;E93{`g5Wx90@0Jc7(>Qnb)?%@a`)8h& zPvbtkm~)eFL^hnKlG__YU*y?rIzVzUg$&~cvMCeu6kcz}Fk3m73?ay)bx4t|r*-1i zBS}`?(Mh>FN92nq8IcfI)c;LJWtS_4v~|VLI9Ci!cfsWY5r_{8M=f5X6nzIqb({u6iDd){SWG(6TJ8(kbRdo}4 z@yTLz9gZ+FkfS;M&2Awk(T@1U^J2WRJmf_G&fv-=#E}J z+}Mx8JZ|zIhR)2T91+1B8=i**M&NdNzD~TS1oucnxSl+{O%nD`;A@t}*XS$f=9FBt zypW4Nr?PQ#UN-8|4cUi$!#r}0+YJh@>*OCcpC$Wgqm|#+j!Tkjl5D4+xx=Icd9glO zyqhtnoNP+mS~uKY=!So`@eJpS3oLk^(w_YSDZIyyNQ}UZjBxfoGxLIHA!l#WiMWSc zWw|88{9+F^&v(Cm&jt?j%%NN^Qh1JVlJ}td-E%N{Ed7<_QsPc2yy9aOUaAt-7Q&bl zR-XK6ShAcLMn`lHoeaLBm38+uvLCK!`G}6ub#555$`z}x9njb&9ibvUd($d)e5(k@u?# zW?tiY9$(m+Oi?X`*Y+!XFKt$M1=MpD#Yk6aUX#6Ht6ZgT)s}K^OABd#&m&^Y@JI+Sz89T~a31)BN$mgFTS90ufr5nGlct@oOi~ z5IU>L`m^7Vd-aOn$)i9My*_lctDNiI zR%(1EG>C7w$ST&h68S93HPWzN2Da-WCFWTsUB!n+1wGS80I{`H5s zYamRARd}#58gF~4F_<6U^Sv|wU*?0KBIEdmy`WARDEh?y%On{KFcpHks_E*WPxCRI)RsI0N}x-}PL23&JeNsG zCqI-9Kd*E+?%`Pt*Jb8>50^h+L?rKDyJ{C;(|x{|>lI+aORbc?&`5V{jVz{re)fc; z@`l+(*87xj+u{n(a2HHTChJWOY;ZXxrgJ{D;`)C%KRPXn!0!|E4{}ai!*kLIZ=Tma zX74%AUB6lCa5qqgUfZ(BB;}yN=WHB5l7qF?=rO;OgU-_wUZwviyn+VuKDM5|+PR#I z__fnt62-DMxwxh}X`??b1ISv|o=6V?_be4TAKoyzBE*OD^uOH0Oms%UlL+Q9vKHzV zffM~X7jdufnERCW?mF}}@Hz0laoR5lv0SIuJfwq{F&n+x1eVr_!0HVVxIk9!W3~=K6PfdKi|5K~*jM$FuEsdt zPraD$lbMa9O7^zb$-zd>i@iBt_bpU-b>cn3K9k(}d$Mv}&AcpmU%j|8MSM$GyEv?q zfVW2^dt{1Svq_d_on7Enq(np>-OJxyvFVu`9CKaa?L?nIU^s?Mia@=%2y7o8fd&t` z7n_y@6YECW?|d$k=>o{qqRCM*mWy)mbZ#!j)?mN=Ccb8sa?tu}Haa~}ctzdf^&xBC zoqY=_oTs;}Qh2pEqLWI+8gZ+WBClWRm^q#zQMZ40XMkMU~bhfXJl;;h0;9&m-!w(U>%MN31O&voo>z1IxJSv6Un}~ zxV7{OyYlY^S_GBPg|RdXN4fqPk&^?%dHSk(PG7?J?%v1rj4Y!^liA?r4|z`=_kVfD zoZrplR^7i+bEOY%FQV@+m_4i=I0m~}%kJ<(X<6SFiGk!_5}6Zvf_cG%8_39Ee`R2- zFP&)Q_-3(>wG(rPM_S8p^-pR0=^s?gi^TBMH0*4Zk4csmGIDdVw9fTLxFhpYZ_?8j zNN?9(3kmZ3CDHf1@%Eo6G$XHfYh)hcE;p77^pvf;Ngv|fDArlh@OwCOevdVkt^vjJ zgL{er!y<9&mI0pD^yRg%67|GClDWzo<*Gy?x;DAXO8K}E(nvCxi>+4qz<&jK9GxDo z`Tg+^$UQOV^wbe=G^77+gtq~^$Y;e?Zz|=Q7E8CU{~)z;6x5cy*B$zZb{;l#F#eJG z?t`HyABCza<^{DTSEy(#R`i-3ddcS>&iv>#hT3L4$9iBb{zZReBsrspGota$j`Mm``pbG*$gVfvB)g6;e)Dmv^GvQE z`Jh`bti){d9~n;H-`|;$2zjqZx9fRWxyecbpZ}DpO?}X&Be^88jrNP?b63?F@+6m52NQ3$brfC{O3m_eXAP%R&Q!I_9C_rbcqEYOzcV`Ukn(N2Mxw zALjjJ{Qf4AdjGF1PV&KlKjhbVe;%2`$KTXg;9Mf<SMa`Tw0tes(8)j$;eu z`ILX~d3Gf9Mg0Hj^I%zIC7&A5*GBK2YsDyBYsS3k`pnx6qaX0nZ}Bhj1zJU+yj>c? z!}IZ}26Km_isfV{Urgy1i6K1=n3lsl?nVuz_6>4gV}0?MuWvRvzCB~}@Hf7$3|v?w zWhyVV<~8p;(e{4PC_gM{*h-rsZK?XDjh|^jjXy@I~FLkvQ@v z4eH+cxO}3a3{5PQYfF4EGk|_fGoG9N{D}H@tz_ldVrfr4@!JM+fBtE>A^G?+yp|Yt z{FT5F%-tT&9P<{;C8tkNd7+uyoc>qVSMY_!Xy%FEC(pYjA6GlrNPIPNltDg7;&r|< z&48AD$Wd;zlk%&J<@}d_5IiIbbA!|2q|U>nZ4D&qL5Wlv?+ukU3LTmoSeMDe*d|RS z$f8*EZoZh$@!Kqj84=_h^L#C(hD(u%i!c6d5{cKP^eVp1qvN-}^t|y)QqB#=d}S1x zuT8_({^SZH8%p!5^at?yS0J}&|1k~Amgk`?)J{&*XK-tSAG$q>g#T|n=4kU!(8faY zDlvzBhYzx5M8bnS;Fo#%@HRG;(f|CGm8E>Yb%;V8zFzwEeExGS#AP+d#U*d7{7BxJ zXUapSO;@ZW-M>iAR#8FA^YYI_ z_&9vM9D|$7<>F!)L2qfKO%(ntqi3)rA0^fnGMN11@9o|=dwe_8ybd)+v!8Gzxk7TX z#tJ^DG=TZ_k!h&kh<-_WAsh4guW0Fu)#O+=H=xh7=p)w6w3AuA|Hzp4%#Y^d|E|hB zkt2Cnyv;%uX-Z|=2wx0Y6p1kfk z0W-ak#c}cIS{gpw%*QZSYx#EUkIcT|4NLPVoV>#MZCM^JOll$l&V>@Q(Hk+LQP@ZB z_<`{wTqZXbed2HNnc#yD=g2QB(y(uAK7tb2Cq*8-a;XnG(%TDz9+SyY_Bv-HW%K^X zUHUgKa{hU3oyPModTHNUi_-K*GB%TkZOn`)8v`Dy@|kPgP@b>)EslI0$MAhv+|+=d zmds&~u#z#X8^!eV#gC~`n9uLO-6apR`m@&i{+IOo=8Z+uSyOZ;XPxsAIynbuGAWUCDgsm^gWu=ZN*& zLU7xP&g94}tRPo7h&?yI3hmJaVd#ELi~UWqFtohFYeJPc_6#^;|9|<{ZxZ3>%AS?0 zWtg`wR_e}TzH0C?7#zqq6=jkoD??@5y|Qkv1AaaUL7jh@yIPio6K$AzF_hfd0cY4H zEW^lr4Z7I#|5c7$q-VUGAlK>NITX?KnoYe-zu_ViE;czVbLu(Z(C9E!<$m`;a2EOv zHeuP~gJM&i{94x#^w9DQg&dz#Hxv6ZY0rDz;;O@kSFf=g1!obbzKP1d)IEIIlCYsxO~^ zK&*VH&(1S93|(t!;dC+^%O{yI>)~OsD|CVb*F75Hnsj3}-J~XDU5J&t^_|f_ektyn zCnE44@}6VpS-Vbe!!HN?qPNZ?Tm!cgS-AeO44*q3lB_f*oV~)Y?@Pp)Hd!d{Z^AA2 zL*lWE-br$x@8@Yym9LjW4}SgMLo(gyfIe=)Fb~jR!7ZLc)HEUDCcnSX8Sjn+qmr`* zq4k(A^t231hsDdpSO<)37mTZMTHNE~Z);>?AJ$>1HQxylw}P>W=Lyc2m{VNagjYH7 z;`zY=d98wR;I;;{$j$k#AP-o4K+;z`(0d(%G>rz94e7Z%RR-IDco~-G0Dp2@#vh3o zUyIK_yA0j?9FSSoP6&D)0*i_oEH0OY7gx&Ar_n)4ziE#fzI>m5X72WlOgw2=h6Yy; zNN67i3?(<(i|@Aw7R+IHRd~I3J|y*iIw2+{1ntQKdYxx3^P4hksvaxd?CAlt3qjKn zS{xAi@-CTR;_IlPk8cFI)Sw0$^!|~FnoY?6c0C~V-~=1nFgmdKzBOfH5&5+tulWBZ zKfAXu6#pDbgfscm!~-S_>2gpKsyJg&awx7;(2_04MD>{_%-eWSO7A#eX15S%wrR+& zko!w7Lx_<%&Nm#e(K!U&ZMA5|_f_qq9AD%;jakk(%ir5-EWNAz`o-xcY-aB8c=Era zINm*z6ET9krS<~|peL3ckv68_qw`?_HK z=Jl*tm3i^xNfYlMl*D`o6dw&m41aHredMOe! zVVO*iXZWNL6g^FZ9XZXScjRGP?w3Q~9nomnGTa}acgg`zU&lQUm4F_!bsY@fptd6l{L+sI3D+?_NhpWChs4-X!YwH+OC;l?ryBu}~u z^rfyc;l{{A0`izK;mn=q{N{0u*KMo`wwwp9Fh|=oF$8_BxM#e{@lsrdcXtm<`7aJg zOA5xqnau5NPQIS6%m1sNG2n_%s`k$@{jV)%`WJWd^{f7NNZXdUHPt3;yJyE6D?MY* zkJNX%ZyrRQQ?AStWzt4ow4zv66?FM_tnN3 zRvVOPI-Fj`d(OD2QsQis6S^;ULE>d+tiI&}aixQ2k&?a$7c60|`OGmFoFDHBKb|?w zy6A!iYn^eh8C^X)lsGQzi=4nS1WRWevv9%DfzF(7nIYKG6&rL)l*GE=^KCj`E71Kz z{#e^1j6K2h>s0?gXG489GdpMiIYgclwe22((yi<}y~rB1lD@^!JV&1uh7m0zurfEC zS)n{v;@NhM2Vqz`fDT61N#4E>L(>)P#k33OeLoa0`EmCcW?lRU{a>#AAAYVXA*X9g z-%l@Q4~B*#+?>7$J-v&E&k^zFFuob1nkj#1VVSo2Ba znfV0XoBcQ+SGmu%&|4ic=4z3%NsF<~bvWvvMcFi-^G{?QdN%Vcc$QRSGV=$I(76-A z$Ni>7PyZy8EYQ*Iz_Sb6BKgiC;>T&ENOCgph;${7yFa*4fNh%mI86N&IiA8_{Rc%?L?WMp!pA^jQQoz|qft*MD*<~gfO~$HqEM0Sh z&CuAk9A+OT%SHFfy-8(Kj=$ppf9_RlGZZA4WKLX(WNj`JnMs!;*~HD4RdCqHoF`iq z2DVVaHOP*;XH#mM63lgeddRsvwg6+djN9A`NP5Bhtcx`Sj%Kh zcOd_C_DAkqo{21rg83FQRT?r={?U*R^z2Whv*sc>s7v%C_|h+QRSi`T`NRZ%|5iGO zp0oaYhpvLx(U{2nPOCT3s9BqRZmd6SPN7q7N;IO2Sr<7T4f_;kReLks31T52IUdIrFa;7?=adUc*>2i0#QiJ~5#24+ADPOUDCKI`S@LFuRv$ z>ATW#$%3`&&l$LUjV#tTvXaUSSZ}A_;XLc-v8?MKNoTJz^ZfRwW6Xwpe0)sSi3~&| z)*~)>8j*j2%;A2z`p+0qJIIKx&FEJ;$7~6nr=%{)M?q)uSNDx%28?*c+SAC<^eVo~ zhvjRsk^C6X8q3GU1vqT^2_++q$UJJq*N_67QXBCzhOVgX%%5CGk6Z)RrmGg<@+Bi~ zA0lT^m7HXflN=oEEYq!=q*l0{+$(dC5sSzyj&PBlUF;<(hF*n(HlnZRBIA0xi3{0B zpX!b>&x_e#x7=lX2X}eX)lsVMwUtt9=0&@Fgw=9*q>zKKIvsB)=(%s-$Cez-M z2QD?qd)7U!c2J=nUb{)cS3X z(s~N$oyZukQQ*5?flCo|q;f3AeJqw)TgX7}HN&F?{QAFS96Kp6aY2bpsZu5_9TkXJ zMu(!OA3~4&p%KSd&T@YYTtwgLGk~!4^SK6|^xJ!k_$5p6eOO~J; zGtRd971SJS z&)=yq?wg8kMHM!(wzFb<0HR{m^mIhynkzHglgMoxAy?uXO&=v|KD)@4e2YeBj+Jd3 z7hiADlUkLWBLA&j2zyl>nC)IejcWgL95&!Mx*rYoPqM?eqj33K6xMx@!sIsm-s?PP z>dSHTiM76JSdnAr&oBC*;#eOWK$mG)I%2n_GmHDb^HTb&o~6^J zO+JU*$0mEa9+M4lvE`WL<1VU@f$;(9uH zWLfm5%roN94%S918PPq7=aTCRFeKlIrsN!_XXfKXPcpt0nN2p9-0#tR94jDC%&|55 zml6NoG2(s)j>(Qj9G^|DIGP#o>H?_$XIk!MmNbZ@*n)O znrE#39IpmG=0T3X*s;b7pQ~3%8(SHv4+=i$d-u%LFPmK_?c=Pl-jAMn?AHg(=@s9P#|O^(GjLH;dFkj%q+$^FwP zbH1^+v;L68bvDTApakiEP%me{>Sd^nQC_bzO4QZ^V)>|-pV4{=Wk0A-Mb5}n)=Sjo z1M-VGS-q4=vN=tO?OR=7ysE^9ROTGiQ{mBg@`^Fc&6=vh@)gc_FRtkLi1%`?N`y?H z2kfDWb08|{8mO@iN({(X;aNBC1<6KsJ?VmK@h%wj+=VVfH3mm=zd47TqeY2D1C@CB z&J~Y`tI4D*;TfXB%MBI0i?cE1V3uR+XL^$bIcbk4qS2a$gI(KbbcgPPaF|e=mnwV4mDtwj?iEg|jjVTIl$=TYj9o;r{PTK4(_q z*^A?S-I+h=rm|-y^k3`|nvMK-kbAjnK(`{!shIV+pTJod-j_#^QykNj`D%Fv)N025 z-8Am)jJrqrSXYzN)oRrnlNjkv8cq7J#n7d@E;JH&|W6Wnh;qnGi9 z5sObUzq&VBN3w()*!%PDYsRm}tR2mv!z_S%H8b~x-kd}EV#b!w%!W3YG4dU2IkT9f zzLrs>z%H^ z9x?ZUL4&gX$4k1}XCcLx-kCzy@3zrFL%;rizj{n|lTn5?^4DRdM25ANs~ua(KgCL^ zFt8A=9lx^! z5qgc;q1J)u=^BVb%XBE$gPy;IQ5b0zjg^XMRJf)?nBoE&3?o}GEgj`D(#Z~{BXv+Z z^iK*9{k8xPO39~iZ*kY04>dXNLBri7baHE16{M7)RZg-qUM&X(sN~eXQfb(Vd(?ld zvFpAy292Rt>K`j8&jn$zX)vyZ491+jbXfA2YA2bMjZtu{%=ct|6fE4^)oU4z{x8YU zlLr}6GaaY62ih8Kf?Fh+_J*A6IF}Fm7j%Ge1|y5t=IS*H;4_du!r`r?a~C&ptm`UU zSGvk|i@T&JsN{JHXBkdfWB}Ls*Ig}g!chU^cm=kO=6h0Ig9K~tUEA^XM3Q%yqd|BD za{b)*y=_UC@J$_ObGRn%Cf~^Q!Oi0WZabu-^&=BTpENNWoG#%f`RF~j0Qfy^QXtmb=!j^4A!(q+jFSp?aw-X-YSGJ9<7JaeqIrOzf5P zDs#<#e1Lm`7-miP48X#4vPF?PgdEo~k2DH*8%CkkMe-oa`TDM7rwuHm~9__}tG zi><_cawGCPBTSgmEgd8IUYWT!9;!DXCWLH%33I#d=A+N+JXF}jp69Fr+{{Rn1Eq;F znT*5cZ3Zd&dPLNVjM8^BvyhDJnTL|u+p9!VUQ9KpE@OE3H z@ZLr@<06ff_r->EDCv`=+L%PSIWJL8lASl)KPW~rEBC6?jWk=0e9k%6)T&Y1K@C0Y z0Jq4ctlU8-V?23>y5ZR3!+ZD`@*vax&&*#3a%qEWBx3t*Bc9Nm)S)Yx>DVlEsFRIu zH#pPREE|{Kv!}1J^1ej=%zU1V!7zn)!aRkyYrewU!GW`*@rT6R>yX%Yp~nEk@*@IX47?!3*$$9nYsHO|Jkwe-}wXXD^PdcU41yz}X?WC!_>x0?^~Hqahfk<*#cwn-Gp?-NO*uk*tgZ>m_{8u2xUPnd5wqSR1)EhmN#;%mSLttkum~$oycY z=OG)F-e=;rOmonHR3t!RF@%k>lP@=EP2lZxCVphPWm_ms-vW>&cU zq=b2D^!#nI!q_dG?<~}yN?m3&EDgf)8Dt1glHYqb7{vuTSa=Qm+%$?a3_A2sM8T#v z-M*P*DVxxFYe)7 z1ATv;p3@ttF2JX7H)(c{{5yG;(SN(hn3l{oaCeoR8jEb*NalS3vrNa9%9`y8c=}r; zbV>jo{|dmWZGkY+Wm)4z0Intk;^BuVyloW)JksGe@4IU7{W?*P_huhW=zQ9Q`uvRc zaGx=}UpkJgONXLb0ZhCnseP7=WgPEWYUSfyf3B&G+llocr5u0kB-husk;<>#r5=5j z$2KeA_<{ANZ&s*lqN|#-dQS}&$>V#`Fk3^GtG(<2c?cMsf|k{g&&)1ZG>1h3{~bbrbfmgU9Bh=gE9T^PXowNAru>dP9}A z^3u~y#yNUO@|L!8X1SBRT<9nvKP?i${m!~!);NB?9GWVu@usUa+TYTk`Gg?+J0%eA zCpFm2TGgzh8XVrjd(L6>LGRbWzGoEb2hs=4HQs8v3CnqZ*_L$a>oVL3~e{Gin;{6)rl-U}5r zjZ&lM02NwUxiRxR97kixmp5i^aG4e@D*ne1@|sO{*>SEBH@b3u+$IsDUh=%3XT;D` zbd%4d>#sZKbn?xpSw0K1+AzmvBG-xcblH*rntoK_ZCS7I-o1t1+NFsyfcIZN4jQGU zjb1KKX6`hv%=21sK7jqEuTz<==b^+y*2mv*O26^^xc?<$0ri8X?!9+&L)G-_4DcXER5z}{jDww9s6g)Z(}xWE#&aYqurmW@K%vM z-(A(p`(JYBduGsAyNdkc3T8KLOO#!A66IC@L}{4F*FYaYT322N&nV$^hS}G=Mi1Xa zF3udz<3x*5S-fBJX1|@D;X8GV@F_81@e=y}9E{koAQ2B=aNdgjJ(U!*7`yQ|-f%t`8$$%loZgVeljm?>SV9jjm+hIrr6l968hxMjXG* z8u_9`1TM)&RDL#W`eq^IDw#cgR(1uP->1uW=u5g8L+OKVLhtcoUayn6&W}%&|1$LE zJN?Hn9unW0NwUR5FCW*s;L1TI4s=%I9Pc65^;Kdl_d%Cd@n`#L5nCJvtH0<;s2Gmn z1GIP;ZA6l9BIfTkVC`1khefciZ)QC|k9pTu$iJ@6!W1j^%9Lh=`(?o;k1TAo!g~p4 zChW4A)5y;TaAe4QER_g`zIbBkMhuceGBRG<+sd+AA-rVta+Y>+K2OCU)VtE78XnS2R}lk-2BzwFJNR)r3|52eBBGIPKm z+0ai?ESnnnqVu%C)eW*oZHCDrV zdnDAXI}ZI$Pvt%*nNg)sy!tRFdSWCjY7;(x%)#V7_VSv%gR zX(yL#f5{_0|Ndr?Sp1YfSCxx>-5QAU2{}Xu=5a6KziUb=c08s>?_Ya)T)RY4FZ!S~ zmA-N@%)#a+@Z%%U6DS-rjZ!Q=Qmx<#S#ZcIkl)rGN1UO_WDSC`$$ja*<4Jo z*-+-4E0Spye6ehEBtksX(2_jkGKZ!zZ|hHqXAaPP<^tQMry*e(dC44Gxp9o=#TP%M z&Sn3kRvJ?I_+|?mi@73?+h|{W^WxqrCKVnxbFpDabLrqkj+pOrmlYAPI+}{PzjINm zFS*Xmzog_7=j5kG;>G1u)Nsnf^x943#pFU6MgFwpKqUP5KJQzQ$LlryedT`0&Gr0T zsz>6uGi$bUSkvTQOF6h$!ruDhY(De5`S@Q4d3;uGEH&eQOV(IFv^Fy@yG}AroAF}X>A8uNhm++Ih*yqU+zjKiK!{{6BOinW@65~>tlini_w&R+}ZE}v~>B0Q* zJ_6fT(i_2_>(r>pV63jvWRe`3ia7D0(FCl7D<^D^Eg7C6e{>uVE1|^Z3klVZK$D z#!{MDEX$wyyM*1nGYVu<7Z+HUT$wHhtws~y}myV z?T*0EEr}}63x71=an*Z!D$d37b9Z-;ln+0p?NUDfY`*@5Y4oD!VwW_PE`5rn#TND! z>as^hUVFk`=0PX$-)sF#ig-W&E12iw)-<>`&*NNTeR<(mD2I5y`0#js&(Hn#2mV}J zTZvg!B)8aq=u)0P_m5PRz05(Kke6RA+NxOGc-)@ib#H+kuZJhd54LJ5jqJ!F(zk1~KLRr{$zz_$h0D0>Fdj?Bfehs|W?ni45@)fZ8r5lHo;uQnnN zvA-J25BD3k-OYzD}f#=r$2GU#eQ~YcD z;o4I2*AwV1*_?~hpX|i(=1-aH;g9MMBQRk$=c+=;vuh8?NqP?#8kz6e&ww7}$mTZZ zzGTimsmodUaTP+bkoS07N;C0fH+i?Zu~Ib31y7m;dN8a;GbegfCO&7EA@l^F zXRb5i6k+(-jXA151pjcsgy+GmmDBkYnhB5X16U~tzu>2FK4=8L-5c01SGq0-?!9)%75>b&aCnE8x;(fUIx_RUb%UB z@?2wM!kjXFOw$^YwxR+=?-y-BspIKOh%2n0eE4 znR&(It$^OcYE>*yk=wdo=*L2##d&7egw#OMGgUR1%^*9zzr&di1 z=Gg2PUp|k=z%cCO=R41fd*$aA#5|7?|G&w3#Rucsk_4>0Y{s+z3p(tHmFaHI_;*kU zF7bJ`#%H2zEIpDn<7NE6u4t?aLBJ0^Uhw0`G?56opd6@y%dUF z^oRQKbF8EAR#uJY94)!sBzpIn8<^2;#;x`i^mdPz*T-Fv+J(Nw7J6JEx4ZXK8E`&U z>e2J)Tss6a4klnX^Q`Ss%JB6ouS=U;G4=&LssRREI7#1PJoAW|y*ufl6MR#H=|W3D zS1+D-!DUz!y-%*VJ7FGw?(?ejtDeY2b0-U8-D0KjpGquP5C#u>1Ltot;dqC+*s(EE zJIDn??gV4ZU_E@-WMZ}}Ki})I(y56HKDmUV$qe?NT4eJ6vkWa??w3u>AAf#21Xs(E zJL2`Kp1s2RNU2^X9d|}&MJQIx)??hn3~UH3L(!~Qsn*67+v$EAcSVoV(HY3U#(!7H zemTbL?fV@ec<9G`_8%EIb)yVftM|!8xMC#p$6Jrp!!DY&;zPVH4dr!mC3$UnOY2rP zpvi|!tmNw%&GXB$+6jy3g`@=@BW7k|1?R(NCd5i&XBTw18G_$DA6vCEV-Y{EW;q9B zz)p|C@od~EH6p{s+jOGzh)n)$OcEpT2GBMa6!;*^d#-Hr5U zdnA*6vog+x9FXH4E@(C-6w&RN+ukP=z3W&|P)#pS$2&tanY^=?9+49{<2TPj|9hMy z)#Ld>-uchYdemyp8UjDxz*GCBksZWlsZb}Gt^L#h` z%j@l;|Nnl*cZMn{o10jte0jGv#k%RT z_fig8_42BFJ1FJeoXcI@L$;@EdDq^vC^J6gervtw;^%$6+IQ%eQs@3)uNM^>ru_V) zlb6#N-(=6X1{w4&QA(M`^o-2ynN|jQI?E{b?UUrrn*?zxV1GH;AfHN^2Uzux4_mIsMEP*Q#(XalQ({-91t7kU*E%RK_;dK}s zriA0>N#+Bx-q2)gIKp|jTXhb!s*N5 ztmR}a))&(Q%zBc`$S^D&5r)a5v{=wD47FKHiJl&cwXCIhj?iLHKP_Ihp=;-K7<#qV zV)T)4{O&DTZi2=vf88O+J{hd4YOz8&(diPi>VbA){ z=SJw966t;;%gA-M5&vAuI43%ab+9I69dFVBQPGH4KlV$0WaAa<8DFxQ9msk{1^%kl zpT3dYWMN{Y84oVfAv-J!$65Pm_R|cnT-Nl*lTGB~ zi(<`KzTAw7EwiARLw^r@*0Ke#5iha$=+v_UHbV!!Ju^d5RT2Ot3;@ zw-P!1MgiSfiyW{ml}hwMdL5;Uagzd{uCTA$!U|hcm_xn6B15VwkWn=VHt#h!`Ba0Q z8V#Pe34(Xz5Y!m z-YEz{Z#3|3Our&CrGnGg$6XnPkPT6|k`RRkI=U3Uv9DrBZ=xz1yAH6oQOMk>iL9G< z(V^P~9lC@@p<)E{6&;uz_>S2Q<8+w3kvVyNna8w@xz+3u?`WsPQWv@#mymrdBG<+G z|JP7yY2V@ype;<^_9>t>n=Hb$@tp}ZpjoHJAFkv!#0t4HdFazmG|6xLx zcIh}-kcM&W7ZkN;PySgNnmr*?)iWL5@5p8yp<`$wxvCE)=3bfbVZ8~_wJsoSD0|~m zO&D{M^NZut@Ga4V2j+B~KV?F(oe94ius`zBgcu85a}Lb+x|N3er`fmposUV^*h4C% zFOI$R!%dh6eVzC72lM~uf;j#?4`Y(pYrjffk##F$C;AlstI7Mbe_>$XqA&e%&U7)V z^3ivCKK3jkuXw!xb!*dUF*G03+55S@njVR9WGY6}B^Qy8Ug`o&>YI<#{N8`AruOW~ zto)+@<&NiJ!futQ_BzSG^j^gLc9u<9DhW3@OY}NdIpE_aB?&HasbM=Y7CFgnty&PvZv%Y2@uJi$Z(tH*8u3}zScA13o|5a!6 zYvwI1X20s^Oa<1oS0H%46_$6U-;{o$Q@u+iH`pTk-dIE%Q!0wn7OBL?_%tn*@3*b6 zvX>Q>9xss{SIQ*%yaGdcKK8B349U?7Jc;M?6)A9j1KlG-t#GoZ0(F*IHvupo8B9Jh5VJ37pjzjT*|E%^?nmFm z;2@NY*WgAt{ii`1_?rSSWJw_A-`3!EQUDBx0+{O;fPF*#5zsggaa)<&wo8MR`^YZZ z@%hLpZ?z4??`Y3FysQ|Fmb&(GVeGle|WVP>T$)JkTiOhp|w9A%b;o;|e+ z%yPe|gZ`=x?b}2l<9;Me^`cSaqeJ*#WPYH7$2=WO3(3>Oq~r8h6GBF?M>*Yu{2A%! z`S%6P{lwYo?diDPAsuB8O^7(dj4&q?de%t)A7lJr09{^P({b@TYu<-AKl;Ulra5GO zU!Zmv$5bBwJIERG{74<2|G&Ou(q-m(?8!$1{#wa%?)1QXY^g)mMwm5yDi6ySGBdh> zv!}?16>H(g19@((qPy!B*+&yIOC0Gx&Ckbu2l9lrziIQm(u%_FOY+o99Wx2Ct~yHmUj_ z`%_LdOiIb^_d2=Ck1Jm2dNt+TS%*~b<$tD3`>aUW&}dn*-I`@xFNPgVQFklnHFwn- zFUy>yls!xQy)wI7d#-q>PX4xHYI37fjk@mFBze~H{p__r|BhG5Kvl}V-)B9yG~RV~ zXVC^Pd+WbF>rOSwc!fb~=Ou_^wo!I1NR;vPZIwHjDF5_Ll6{;{sqC2`mOBR7RTM9M zJPq<}p;5kYe$m&KKCaJ3xx*aI1yd6xIsSmuJwTUt$zd@xFv|NodWm^%l+z&zGWBVq z+~~`B79_~Iq9n1LGsyCviSp+$gX}q%AQQ(O6xZZLdCPs?k>~8!_2qu8xe}G8st^{a zMlFjH2QRo{{XjLWGn5D&LDuj#nZzf|&#I(?pD$-#4l7YacIEH&bar1#coQ{NH>dC9EPqZr74p?8>};*VnKHV(zq#VjbUx=l zoO3y*Mc*;>)(@gXt6ey%wFrl%Rv5|$(qVOz`$O&*1MbjaHCPM7)iC^g8OrSVFsQh1 z)K1f4#9d~c{RlzD8DZGLz2ErtT4ZaqnD8+SEMLISS>%6${Ba?XVkP*B08_C)l z5%%7IH~vO!`itzzNxJ^6j94|D+~Wcxrg9&-l7Hu=ZxTu`(jT?ifU*2KVx0j#JGq}+ zOGf22IZ2CwjI;s9SG*SuGU5dHr+Y>uV$g0QezE>`w@ViLyWE>C$wD*7Y^+PoLZQjb z*UEiiWpartSyv$Ia_tTGfRo7_mY8wqMHWP|5cn7W>}V$LwB~HgM>7sj%tHJge!mr2 zp-k>Ie{=3-a2A@^F=IV{#@M1PG*yykJVf_nlPq|w&c?=}%&OxavYA5`qF599e|g5) zg(`8=w2%)&oMa{$xxbGq<;OF%j9X=qijGzYx?+X#hEmzsfvjFj1y1}7pf^N=KD`1_ zi5!Lu4MhIufd6G;E}tI7S$ED+T&GvMZxnQMqo6&=IR$UJD{iD=OSTDh=Ckic9xP!% z0Svr`?7p3cVY|4V^LkOWfHMjY=-Bdd6zlO$lKg|c{L^mIca58z;C{|nS|-U8$m{L4 z!jR<(l(SXf__F}qIzlGCEB9Zs2V?bYx_n3YBYmt6yX!_{u8JP(>d~<69EE-S_1|@O zYM=?f9+=QXPcL-ebaebD9ao}0pj(FmJeosBt|PC5L&zAsE5P;5ZZe6^@^#FlTu|gJ z>DFyzxLs@cx$w8VtxzhxZwnjUYTAVe>t zmv;#{`DRhbc}E6gvJRj6(ZkJs)``&f#@c~MSbF)GfQIS!u`2c7PHp64T+pVcp3!xMTIAhjPE_`@z@o7qBo_jeKB{*E#~&|R*jDrM-4QaRtB zUbF^Q_~#n;11}XYv%Y^YIRL#62EcAe5PlEf`}1%xvTp^Ty>%3vx6_3@NQd&?+{at}CWeHu0|G~vL2bkyS7Hi@jtH2SS-d-HginUBV`$i{=SEM$2e%ypB~%i4)k z+txD8(^2jz$j)?gmDeR!*d3w3*ah^C>J;$c@w9?pPo{@`4(E(Ee$}8(@4+Z(O`ql^ z&Q$O->KD!RpZjWOuI1}z>rk^=6gto1esz}#x>o7f%Ht@i(1bUyIYYqL5`Hlc@-Yuz zrjV=DGDE5;56xE7IQN?3Ji;{RP{5{B&f72rJWf(Rt<@NPEXS@GM#C_KIJ6R2=$-LK#_|PZ$6MOCrj|}2IgLqQMpuu8IaeRUoa&bz9SUg z_0B20dyP?e-@2jj_8?zy{}OYL@(;=Oaz=X5jWWwVQL1X_vfONx;?}NcJ5h;Q^jBWu zeCWDfD*6SvDaW-jD!@}&D zE&QAwu?`YPH*rsLpIp1%vMyNa$oGUy(crdOe)N;#9| z#vBU|Dfrb^W_p&%urt5qv)UqedHtC=og6&ZjX?+fG2(ato}SVmCxdH6C|$=vye^t` zI6q&9*tO~@oWn9}^2jR$Ne@t4S!>?|1+5ZuZiVHcDHJR%LuZLT2o3Lh9I$j)0<^GZP zEM^m`nM}xBKqjssImSX}aJv_vbW;H;Jj%z${B|-iw50@EwGnl1&IjypmB#noq+$l= zCcaoB;U4EzYtTLT&?29PDexdO2pO6{OiBvGx5Y!?N*=XqX#n}}NSy!0dPVIhI5mvs zJa829Ogc0#HNkra-DBI+@N9+&SB98SnXj?oXL9eq@)%*rdyVE&InHu7 zrG?lZa^^m$jr5J8r_n|wEjwDIC+Ga;wzfj|RAzpdtl+kQv$dW)^(oE?aQ&K|lLp0N6K1VQM>f~@N+D-Ye? zlCSxZPwzxN0>e0$S(S5S9bDwcS=I$SRdne%N!=GtV))Tg4pn8A3Gc^G6|+wE-69QQ z%4Coyvlbo%;ZZjY?#>LvFfCtGrUnBiXmIWadCF^CPX|Py+$kNLnn$4v?@d4QKJa5j z6J8xjL-7*2vwb;JIyxQgxYww1AP;fncuZHw$JZRrmhC6oI6huFbxoA`enzQN!p!?* zy_Ci#N=|jo&~H;gUq=nkAu7aGAOki|iSKS&{861VO&MBr*g@vJGz{b4hv47qWR=fy zCTIrdhHSVOSJ3;%{qyzqX4s!M zZzAjc%^(Yo7^Qz@gY^H0HT3&QGO{R9<}FcT-aI7+4O7E3MG4ahI^(x-PHP{G|-s+WM zhDVCRJNK}{+jG9c`(c#A`_WEvX)AnVy9Ij1$ih@?<-P1!q6}@8C>^#P zmg@8|{J~zt;-g0Ca7=~26Y0=huY`Mq3O2vh7*pngjZ5er7{vJr+hs6tE&cFPi?MlO zoW0`fxM)ON+e9QcOoUG-W<6JB-qA+huXto(l$qSXE7q+G>5k`n^^NR(c!I*40x9q5 zQ}{kzBYV1lj$w^aRyZA$9Rm$Ac4@p^a56}PeVm`zpvI0KDwNA%rhvN}4r^4f=4UvX zeStO!VVvb+4`F#Y=bXY(E}K68mGmFJWM1O$L>%V5)x#pX_jx}zz919B=9>{a!;H?a zSwm0G!UBF?jk(8IOAeyt8in_1@~|zE6y9Fk2emv)7QZ6r6S(hCpU_L~y$ND9oH<&j z*+*HgLI&@Lmj}|RSzCo~PytqCVHapofoppgn{Z6o9}Xuwy0f=4uY4_M*;*RW@0Jnq zxdz-GO~!Gx8TC76;U+&fk13p4<8ht-gR^H|oDJy7wd(|5S7m;7Yw0?U{Qr2ye38G${K^ce2QMb`CZ z@_y3~amn<9pC29e1Ig$6 zHI;~nV%a^+2W_X3yX4PZPkyS_*!nV9e#xztJ{aRb&WOCyiB-99{?NX(9G%^p>zc&`ch7$R_!x!@-Be6W0v-+dx4Gd`@zxscd2Dbe7 z8Y7YYAqBUtf=1jb+o)Qfc|89~Nlnog{yn=feErAB|-~N})9A=7*DZkr+aMV(HI3 z{1sVWl)rz8h98QcrzI5+ zdEUKjSX;VQ{~^aNl2hY(dZrT3yCJ!VV19I!(L5e_9A@T4!lPd*UXRGd!MsNDeE%=$ z(uCKIk_gO6<@Eu%uwK?g2Czq$FwCDBrabSyr=o{TE;45~7n817!gE+t;rSRnG7U?g zkmt>@6VKve*)uo*6Bf}MSUC;Hp5W>%rR=HthbTl9L7ieMfOreV!xZaK~$uJOaXph&d+n2K?F z){^@-mtQS-zN`yCi)YMt9+`rwOLH-zc{9lwP%L*gGJpB+NGO9+;ocz+VJ&z(2N%jF z7eDOk9*MC@sm#zLCpe;!oUij+QWw+58WI7ACcNGrCvRxyEXN1_lJ2}OxOX@bnfCN| z@c3D4w38YBMKY6~N6n%LY*-+(_Q$xbkr*|L$NA1&&O6nWZ=(w3 zODlhLd$SeI2c)5259XdPbCC6~eoECCA9#^BJa#q}(Y(&bHEhoOy6+O}4dN;2WTstnC{#L9>a7lfP&#+t#boBnOa zgePU_dgOqN-O&=`tC9t1MQ&w2ePO@L(D_B2yddXtnmM7LR{=^1V^{DqH1F0v=@T2ho*}cFC zPy9on7-hg}TYA10mBFpfUa3vq=Nx@ub<&xOeJO+WZVN75ijz(J{*~>)=;UGG{()XI z@->Us#LM{(%%$xfhNouc+a_kh%ApMFr^U(FDo&i~3`OZVJpvzR&|j+XzDs_p?ksXu z?L!gY(|`?pyzfBraZ~q8{nO6KvI#}p>japlnQ<|l`M-MRQ!jOa+KKz$7YWQ1$Uujw z^cd2U_}1itZm0PC-t^f$ra!4SIiq>;(xSix%O3^fOpzWQlj()LWx>&7`^4{qGu~}s zw!#KI^UE?(y@J9!VqTmq^K!%l`ULw-B)@hu6FamPfc)v8GfwDVBN$sw>Tx zdi}=JgGql}@+k`roAyiHe$LpGO>Q*RfK$UV=-4mAmTIx0pXQ2V14D86sh&BK88|zJ zye&D$mGfNS(~WsjB?;)CVut$&3%u6GNxN3gi1!SEIhWo>9{(-LyY=qBU-I5MVm9-R zU$FPkWfA=c9q74J>Sb;&y^1<|=+2W*+?|2W#ieL)ley}<$gxTY+T7IR%=-+?>S)2w zeX;U#q7%k3S9$??&+8jFvwFO}7(&vz~NyHgkGWz~Ksluii7ivi55B0t#7-vS@U{nE0hGmfQ)q9S`L z?qbH>X=S)n6e|&JoH61E{fu|@7+RQtro+e^4&nL8dn+gMiS5{H*;y_VlgaaLRN# zL@RnTFUH5nz!+y#oD>2Zz7G|@XX17ly__R<%Vp-C`ArN(&x+(R-)7*CrOc5(v`?av zoKb#u2%H^QW8?eTqGuT%PD+plIv4C^j`??9$13xDi9Bk7P1yli8|sSRmSD~sGnY9y z6B*|$7;d*;YCAdO;NDPFU7$zErVQ4{$QM70lj@ExsMwR7CeJ(P8JRdo&e|;`PHe`y z;@>@?ND@7|?&0-qD7n|q2c*juSM=Qxj5$*cNN^;-yxxNDo%YK}cX}rWhG61#J;IJ= zaBkm%<|X^2i0A3ur6IUa-Y}pouiI)1o@&TxE_Eia5e&_9@|)YtIFMC_S$FqI#0^JG zzZi_sysj2bp;z=Eujhe#rA>|_W(*C%+EIF3<@@}!53eUj_RE7aE_mk?f+-*3IooB% z@d@-!wvCYohh4F97eC*n^gsU0z$JwR<;%y(Y0i#MA%{MpuO8YKnRI(tFrI!jkai|NTz6PTwuiJs-;wR4G`95u*_*fj_To!^w%k`)+%uIJ_ z8UE}MD~`O*&!(?)qm2PSczh0GZSlW;SZjqsad79Q=11y?@VEc_@BjY#|Nj1ef9Joy zTj$Gt&qv8(h5N}#Q#?G~S6BA5yEQU-!M%s)eWJ#t z4%N;`xn&GUQTMo#5*&O!*|~61$_l^9sfDk`rD%UAr98WFu4_5F$I0c^H1$07HYFwh zWB23_V{fF~O)l|jly=AS^hh_aO<&x-zK*(((&ypzGjPLvq-Eu@N3hE<7|0=+>T!a1v%e^6fBI3$bj86~(}y!>&1J@B?`C7ks6ty;=Koz#V*P$*RI|?1(!zW6obIPZ8=p}8vJZv*LoInG@{TUy_}exN#~QOIe&tg1#y;T( zabal78DPit%z2*9xlxxy)=rIBev5sTCPvKI&0bHw0RxwEwsax6#s~v!RxwLZXMj^% zGK*JgU#$_iHl-w9kS+*oPR-uOrRynV8Mq7ked{W~fmMTcUhkGpi4jMHcJO7hBoitBs7b zC}r#)9)d+}nD0?0v*}CRy3>m6ofTTJuQ;Hc6?T@lf^%xAjA3svO3$7HSYNMcjW0$E zIq=`o{Z*;NyII4bjRGM7)-Zllp#2vG=Qu6$h5d@#@nj$M7Mb+4R2&|#Uuh|o&txTM z`H-93!RO9VV8TQN4D5f`cA`&bY&rNhXMUp2ADw#yaW6qHTu~r`nX6R!l?K-n=v!p% z{Pi1p`k!cUne~T1KLo&sd{y1q^eD1cY`=hEBiBNl+Q0puEOHF$q35EFfaum?dHkV_ZcZa(MyKsc5Jz-?3@J)Ihu(xc#E7lozv zv6evH|;4e;HYq5Xql#czwSc4BGTgczLub^jf0rRFO(hp&M0o!|<=qP0lAel#vhFP{H ztlhKcGm|y@>3zsGPNqkPkH6ziUW?Ds}@`tR4G8f^gM)L$VY`B_E+-rF{pk4)YA*_ z;Z`1&-emUWI(j9J(E&N80FkrFK2D}@rw4oHITx9uhC+W?6L;HqK63@){*BWQ}(Z@yH{&trVkLI$}MlGLLwUPNFlv4gr zSBXzn%BY@BoXvI??HDK79_}Jd+BwMAMQ(DT#9o?oc9lo$(-oySiEoIb#LjS#4p&-> z-PiV#aJr4`dhRAWR=LZN55=(#7bg!KF_D=zd6pe;Nnj z_{9L`K9L>f_l`CSfTxOnM)eT*uG4V7QUfh}G9DW=Xl5OVHdY#}ZW4$wD*`cK3BRt& z^N#$(oI3Pku+J8uWG^z8wIc@&BqR_`#s=a|`2d_N7la23194(B|GvKlSE|q_Hb8?U zo0 znEOnJGd=nBUDn#jC5i|6$dCL!&&4>Nv!|LyVM!sqCEa=Mu=lv+OB7;Q$IB$gvNeQ% zH;L!vEczcy`SWmHERRnj??L_et;8J1=2y%msI^h<|F_jIUd^1Ne>v3BKjbgx2Y zk<9OR_6t*cr(+(^hr7GzYGhAyacDYbkblg&pN2he)A78X2?6Fbw97YP*PApL1DIzz zpFYP(IyhR=En~|bXlF9WuQ*rfV8Y=L`XD!^W6W4O(!LhpFLJx3^5K6D(%Uncp=o5V z?Hn1$7j%;HoC*4xhvy@iCC5L@38#-{0Qr`qdH8pI9+EuB0P`G-s!jjNJu<=Uu~yih z&l&D~%&SlLBU#106$;RgU$=GnfRF=ZhhFDnCv&Q6eJa4^HF=2Q_nu`j&!lr@uMs7q zz4YTEy&i2^>2+PVE=6^0PfD2Qg%rnSF)5R3W~Cgp)+N7PH#xjOFe7OczOQzkA0q}$HvQkdba<4k|@S7 zdP-K2O^izr7uPr$ra3GJhbD-wU6PDr?ZtsEn^_e%jIxBD#y4;EQm=)Pwdh3IQ9VI?`XtK73WsF0-6450Gf6&dWp9i>du4m0 z=vNpdrqOXJ;U2S3JtbPqArmv5dDF2fY|Kz&RCO0jt)pV@sw;NdxuMZn6+)Y-$%ZO% z%2tgRCLLl$=pw#U3?`T{%Z{-4)e# zt8jO<3L|T%@p%BV%JeGSo=8`CunKjnGV|Jpy`a6^zugXl`wQ;VioE5`Yg zgGLDN=_8q-MZwLGNqKH3wr$J~rS;pVAsLgfV=IdG%FW2CGAG&1@((iqijKp@xSnfE4ye5W`g7zBmvJ4)bKL{1XB^yC2V$T{-Z@K}#`D7U%G8b+P*Od(n zxc{D9B==zdeGRthC@uObWydxL@jj%I{9t?O-M~)9t*(-VT!&5U!ma@UIocETqdZ~T-xC2pJz!=t0nK?;KGq7u7_L>`y(L=16Z#&R zXv^`(>J1q=t_SX%Vo!QoW_Ehg#d@XyVSMi!m2m!T-d%deDdovqdWUaymyhh1`TMR? zW=S&7kM!={{V+9wLtMTwm>EJ^X8s2f8>^hraX@mkDxVD{ljO)O*o`~0ZB6grB z`f%=gaLo(jd2Mo*us@|~1T-3YdR^)Idq<8iAQP*(-ucffHJfvS%Vs^?MrC5<`XX!@ zQHb^ma-PZ}JXp!T3mbYP>-CaBm%GTo$(?0nLu)zmKq+VEDrNo&lN_DT_3uMElsPZ| zL3iY9U!x4$Jpuc+GB-5X6ZejK!pFpH?h1E$1H*CgGIP}yhSTjIhRIRkC~n2;!+SKf zZzk$A$;7kROw3%Ii8NobGY`0yT1`G>E9VJaA>7|HN0i^YTVf}nL#(CjM<-dlxtmPB z-9rwwvnB^(lEs6oBdOR7CeA3+%*|l&+$e8uc%YY_b3GZ$M;0DvobAaPpcj5WLhl#n z$O1AUuQ!Atnd{JVrR>>hk%=2z7Y<#MiS|3WMl{bv8F`*R2XIa~QGg$_il8{mIb?Ma ze7dpDukFVER0ruZStU1W^EtYpl9cu;3BFb(a-UA~6=8Um&3v)1%u6Td)Mh-_v`(31 zKgh*?F2shpg$QiV4AIH-TD>lW`SAiQe3u~ZsfjXw0=>H&!;5bwN&ECT86D_=OLPE@ zUa!K7cS@vGC{gc&13C@}z~mi)$R5S9EGH2Di^*ef?;IVY#npf5V=Q7H-&_qoa(o-J zkvRfU2H3R9#qVS2dYwY=e`}5#+FbPKS^4oM3U!8-nY`o-nq(`~vR0v<^GgzQN|L0f zxkgrmC5s=uz)P%>B=?FVUM^Q5aIq4NhC85Xej$s^=CUrMpkCy#<>zI{UMfPlhLhawt zOnrWeLOtd_om)2)>ib`kC47KZz+Ql96B6X3w^sHflke~Eh#ogMf8{w~$!)p_SE%6Y zt3n%&?RB4%FYw|xAI923SP-1Z5N?g-_&XyB-4^gOSu?lcz6SN*(6{vqGnBvOV9hQ1 z8Ln`A^fTaCqa3W_pRJ}p>VYHKi+&3Ao^o;+hZO1-YZ64wzJtrH$%4?~w3EI_^V4xM zt_l5vEgexWUx|i=N@&QR`cGHkY9{lyQv&Jp2|&Uto{=mddqGC!YNsTG-_+vYM@i6c zOo9jR-Am3B$&!nynjE+W8W1zYfV_DIZ2L0@Z^;in?XOTz9;i^aB8xFNi7rAqr6$)o zC8s)TrPh9pNVHa3F%#q;*JQb5uEHCI5(~bNBiyURRPQd($0%WUH;}tb)?RK0BH$UF zWXAd^AAXY1Yy z^`@N)wQmaRw&xV;_3N1-IzLh7Ha#UN&61>WqE-U>$B27@M(n4l;2Fz)hduV#USN-T ze2%Wnutz)2|2|pF==?hn+r|fAKiJd28qQ44wW&Vr7wE#e%5+|%i|i3yLRa!~&S@*j z-A^`P1ZyXM@;MsnWI)_wg}OVL5Yun;R*qGuGnXsW)^xU=e$ZLE2C8JSuB$A&++D^E zR!UrLNBMljBnmK ztHZJAd78Zxy-~^E7dZ~ScaZ)8U0K_+mwRH8gx<_`er$%=Nw&7_e;G$^X5s1=%_j=D-7v$hI@Njp$o=%% z3D`jX-GSU^!8doDSnr7|4LqQs;W&2xY(kr6JtLy*uFL3Qa9@la?uSak4u(h}^Qx%~-dnlf0*r)X+ zRT`xx$m3V^>PbAWO@hR8uW;d>62ps`-gWm%+nB9O3;Xo}MYvrO(4%gpb z=_g_R^>uFp#&E2jZas8f7!~pg6`TE&CJy6ILBX) zO_1dmQe^(ec-gr-Nm_5#irEV?1>=;M+nBv?85+;!!+-;tO#(Oka*;0#>ZCTU)VSuGI`{?z|Q|1`m@=y*lS{3Sv zt?11qlfRDhMh;m^>vd#M|4EW{os;EeH4XXqBw1GX4+-0!C=E0Y7`B+_8@Bd%)RTKk zGL5|(Fb{wnW8Mw!0du(q()%OQA`sql*w3+BgExBveLp#{fKkvu89iu_hzZGikS#M*w0a?XQFs> z&z@YOmHwR^Fgcf=hfzw@e`OC%7iJiQsxbOT04^j1BDr%AmTwQj`z<`1XvBSMH7zbL z*P^Bw^P2eFT>Hv>W3mP#V+;u3XZo97YT;*ky`KK#RXKE(Db$Jl3|m|j>VenDesV2l z#Yc1yFh8DeY!^;cok*$}3tI6~p?zNCy|5BMdXaXYd(K|Ms{>1(TI7Qy= z*2VAg*_{3|=TPjN#rn@h@{C@V;-oE;>L2Mri=fBNoF3Lk`6!!WAr0vHy4l1X?T3e= z7X52;m~X3eX)O8V5U=RmVA6-;%n%)HbLbsw-c(%X{*YJ9an>ye#aI5GKPTm*@>@qK z@F^mOWRyA`F#k= zn~_^Qz&vYbE4g#ER9-)EgH1^YB3oqOMpNbm&#)4;S(!Zi#5~_sA<(LHh})TmgZ0{w z(=C;YeO&o>55=w3{QPb5v1vj_$)(rq20fA&28AMo{LW0Pd|VjVMzlFUWl!mNY@ZQ| zKi26mmfzpIy_M{#&D_L{{WF*`n~$4;?WO0WN=aMJ+*scbyxfz42SW?kci3KP-~B1$quenp zAQajytG|x`QluiYx z_D@TBv!zV#UUNex_tuqnbeJ2P2bZty#4n~)UM(WOc_b9>>oZUiTL8n`Hj=rhR1Pyo z_zZbK$8sHNt)X*wcMJKZG>WDB1ZFRWV*fgFdDRQhq*rsf)3QqX)5{i5zBT$jxzX|D zJ-@e-4%^CQTO)VmKc?rg7kQ<}c^G%Cl~f)tku<#vR+3xP|J0$$bzaXAE#zxdg+w3Y z_2K>9-IKY%Va!M>q&M)FD!E$U4Qbm$(cl?5xVCxB=V>879xHeb#(wi|p)gZt;6hnG z!h+h0KkLeiCb_{jC=^Qzb+|-NVsa-7c@bJF)A-!FaBVi1&xs$setU;n$evlH67|Lv z3x8v-^xv#`{*ecJuXb{O2%k4z=Zk$p(cDjmUZa_lJE6IF`d3PmnJ&otH57GvGgtSo zeDoyOIX(HO^me0va2oT?2V`I`dBa`{n$a^;BHQM><3MZfOCRYF@HQWdhFQvc@@1cr z-Ep!uuTQEDYmNEnIG*31_f3WkoPZDSLZJMl9`0%D!IZpowv+aEH&o$5(Qf zpRA;k{GiuS=0X2Xj&*eg@^~HElILAfy-HdIx#CZr6%9{kem(2DCFp6jEFvYO|CFK56!z<*xmn(bw z$V(~v^fKc5U^ zD_L-;Qqmi`Lwg_uU!Uo4rF%X`S+tRx4S&e_!){2~Ob&5eIu`8U@44DReDg~sw9pN| ztqI1{Z{#{T9(KIfM&8dV6RTEkyjP)k#_KaCyZ}d-PyNfy3VCpp`R}Vj;a!9K6LQwG zw=@=+`%|9noq*(Y=A?6++&48J6Tdc<5b~JK`qA6lj``6CbZCBw-q+<2gy@h1we3y}pT+xSIw)(LSi=WdI+PJj@fBGpsFS@~b96gnsrw+7Y zj?=0*(bG?Nn|uoBt$Q~r8?{1>%qobKSBGs;*OMN=iwP+2OP^o_y?ftI%ChxzX*0KU z!TJRBbSk6CzSZNk;482Q%91}_Krqt-ogF&nZmZGjP&PsB)@NzA=Hy@7q6{Qar)%Dt_^ z+T$m zvKBL@PTA8-@6Qa*L}WB$e)oAJ5{5^URk26hC1!QzkvIIFg^f`r6wE&%zc;qUYkxnq zp?`Dm*lY~(HPMM2D|3F>ApV>$x-8P*9M`i?xo)&{j+OLjHn3U8vjhH~#tZrVmquhv zBRliS8tuu+ZnoB-n?*Jzg_)o)h$X*l&)zM1+{PwC9`NtA&V*gHnOEDw78`E)qUKxr z^_V04Jlx1W_7h^A&ihCnP|JMV4M&*=-Q9%m^u!&e$Fp;cANp@6hedwF+fJblJ)a<6 z;kMXr>5Eh3w(d4z4s|yZq;a&=)Y@U}6@RQrqc?L;7NXu5@nzOAiQ7a^Ty^S;tD=1r(bd+dwDN%7tzcJuL;McK~r+RgZH+%bn%DP5;`cB(f=^igmujIem0la;W+)3JvFG%XVH~oV#Y+Yy!Exk!@54u zmeFf@F$?pXnvmNqQc|+XSVj9_O>839{n>bU+K6H4vC@Fa)wjMN=z1OJ!gsShNe>j(0uf0z(|EI|tD*kjlfU*z%c z`)BPO{5#f!&<@dZj^E#Zf#W23-fk!8)#Y>8NEs&!_*`w;&F}L%4Dt9c&zgMe&Uo3~ z#)e)Te|#O6fbHG+d9IppGBsM>IN37a#1CW0^O~me{S7wZ{^2NTV`jr_4qv=ln}9<# zaxf`}UeP{rqF!u^zgzlZ9?$3c)*wghVZ^DdXmKQmK4*tNoUbH6YskW)eI_W6B*>w6 zT_0%;`=bZ@V@d$?vLgW%x;P{APpNPkhPPCSqn_ zHj3XHu_h=+4viwWUW4O&3g;J&Z(CCT|NV^fe{3DN*U~CIa8prQNX!_g)CHl=>BI8U zGoCba-qWKhJ#NGKbj3u4Zlm{{^oz|-rCn^kGCj6MaN71iU#D9-P1QZC`OW!9N<@0j z=vB_6A8b!g+-{wI?(GgI|E7(dtM5s3-k4~WzOb~hbHl^!(yiz1PT!Ms$EkPht+YW? zR-_mD9!RToe$=4y+E(eB&8yQ*Rnh62<|Iisez_MX%Z3LDa>`sQ(f`JabHjL9;=*TV zCiA3w#misr$>N!wC~ar4W-&EZtY5{+t;wvb&}VyiTat`4Pm~z;jxHILEUj7hJ^V;3 zE!w1r`ec%Xm&Qu%^BOVtp?}~}igZ20Il?Jfj?l}P$KKcc(Mj^;gI0EJ)X0!Dd(`5& zvWj)$&sGj_Tx*Z%kL=NLs{@{Grz^lmg%4j@&u+%LaXd2z-5v1ip*>*ffOokn^ir#! zIH_b7HGiI7fyO;m_&HpODJu3v-e+HJq&*hsc#a)J?s1L^s~f3sfc5#@mG&^>*@1!o zO(!0pL|Kaxm z*x8il**pXJRG)o~O@gpy66@Hk^?O;f{(nCZgP#Q;BR&8I6KmTGSp%CEgdxuZutY;9 z(uU^)|M;Vc1j6dGKay?+U=n}-71k0C_n>d!8}lc~3_nz9Fe!~==1483AJ<~|Ff9&r zWNt?X*6W`!k6Nci!l)z^E}{qEr3U`f=-~0-dA73#<0~{+#53tg2Ra;j(%+M=g<=MM z*!;cScwXI@XEgOvHHg}##lyzzC+5#?8lnLX(%Be9SH=K3f>-iFsNwE2MdIT+8H+Rwk~rB3I&JI8?Q`8kMV-7jtw>ukkv+DGITC z=GV8EIZ7LuMdN+WC6!p@E9H+<4sxrTqm=zr$|&Eiq8Qv&j1G=sJEezw$?YnqqwOX9 zjICVn)msj>u$QG5nXB8Oy`*%v5vxN=IX2c-e6OgOziuxf?dfkkY=)+{E2VBbGdK@4 ziG5I|9I`OU!lMeLvQF&!O2KuN0#j}1q+eAbdlpn1ABQOfM?O$>+$QPH@=?qfZ{3LF|#J1{209e zA3X5uH}X^8=$YHdI)4*S*04Qs@-GjJ9>5-XGFF8TJ=ovF9P0fO(Cu#zSd(p3O`@mn zEzbyM@a*>T1oXP^fyh+;8J)ba=CTK3i#_nUS{Tm140v7z4(OPndN}fxw z)?GeM4<|AJs$F`_Q1Cp*s7FCfy5B4_;d3+-H8<;_cW0eEUys9{dYZ3=!n|gHbm5KiP3}*PUE~d;t=>$3#SL)#q$9`Hba$UXk7@R@x#2MyAP1fW7YCY0T z%;Y`F%<4^gtlP@-nbC##I;0RD=7p%bT8Q2{@=teouHB>%ezObk-oTs%o>eIKk(D@4 zo+`V5{RV|dj4yyW&v<@V@q8tj4mh4;+;u60B7_;2WEe8Hk=0^PY{N{Rb2MO0zkvCL zEei22x)3k76yomW*AqOq?qe$pGVR5GPJ5|t<0$ikI!mhyw$fQ_ z<>OXsW?pm@(-d2|+m$X}AF?W=QjA7adkg-Earl_j@PVZ&1p@SB`Sj z&`s*S?kcX#b?_~$jB>@?C@Yp5B`&BM8hlkCd7=X2=yzCFsldfd{@fP@ zdS0)R1y8D>wqKRpyQ;urf0G2|Gq19`N%F>#AxTsq#-9J1`7?_iC}78Pl_RW41^+Ng zi+qz{0yEw0s=@cW0=?cUkl48z4nOC6Gn?mg*@iIEKi&t>51Eg^dl`M2ie36^MxNUps270|8~6^f4)9_@I98Au zJ~%53lYZyB!}rQm%>Ht+l2=wT7siX{Nc_s_Mn~#d=7sQmHfzSd^vE#yC(+r+Gt#>J za}`#4c=3JOxre@&s7$5;y}4wET^;G^C}b^XND=2?GKdN~xds-( z@+8ko=M`Zk-z%@m0(?15#&;9_jw|WMn#$bGxrOL-oDN58x)+xfVm{y1@iBCv@Ew}B zoea|gx@~F}p@e67mI?GZ7V`buRD>O+1u%Xo;JT#{-|k*_o|bW9VBO&6=@uR8JHHun zByC_F!@y~c&ZgH-YOA}kC&Ot(<&pHt`EI(XBMRpX|L}DEb?5Z>8iSqoZg1q=t;Q!O zyFT8RzFpYoJbPtWTD$Ci>FdAkciQ}_{F2uYf9KYk>gfYJ9Zox%G%9`D=OMq*VOs9`y%hOmf+|`O< zxmJ`#@nTMI;~!5GWNPa;$@q{UpRQ=6-h7P&ZcP#U+wl?_c}hA}Xl0)&LGJuZ-%@_E zlov3Un!Ph``y|Pmg^4nL(kV&oLD%C&t!xX^%9bq&($$6T?!)8I6JTp#DP5(_L$YL>``sBBWCwf@f?(H@N`Gy zUsED^x&!)hU3sFw5&r&kh_|MTX}3T0y~r=-kuhu&gmwGrA9=})XtFqwYq^fQ#@-dy zLSB0DpDxV53}7a7EL~E+(A6}NEaYm|Nw~+D7{T+a!Ss`5(B;&EXKZ5v@k$+p20sH3 zcZJ>;{_N`kK}g`*v-NWJyIc;y7p_T9dj()@IrGWP=mFU1Q*yrbwgfXA#h>Fu-V>vm;Yz0P6=UG;L>ENo%bJ3YvtaRbm5G_{h zC(~HWUX~rq)vL`MJDzblMY7+`itD{o^fYp<_heBH(rfbE($|1a^$hss9na?avqyNm z0opuf@m(d zfXnC~K&J5xbB#V{Ad+Lzu}*q4I8=y=TFmL3S%~S&3sKXO^LWD|EX%Qz_AQn2u)n<= zZrELJj$XoRBBNy|>)UpfgkpPH^Q61ny5cCNFZSYc$Bb^@>WF_qZ{-=2jH;`ELyS>I zWqBd~E`3rzJ>WFJ3#I2gVKjK6zkfJ;%EM97Cmi+2HvU*kkMCkKbBF249YIcJeI}Ov zP39r+GSubt^rjVI4zG>#u0k}NRES*xMRb;a!WHMPQvbfa?7Q7v+?V#0_j#R}wc1r~ znbSF_GsEOo3j8FCdh;yvmFJKR`Rs`V_6amN?1=~?Gudi+B4v%||EwqNC(=t?7KUw) z>Hj)MkEKmG{^VL~ds-&04x$@)K_*OOL_V>P_H$+der*WxS9aFY3$L&uxpw0Pmm9WQ(=;XLk1 zk7Ylys1rO9Jv$6_GU=_H5QZ6Ck7gBx<4d=7IL32?iL{ROd(o36~LmGqbwZMLzb;j%IBdyrCWQI94c^>plCCEI&X%BE33q& zhee1CaaiFUgLfk!}=NjXMjTbaM*%QHgbbV78mLn9cG+~IC8itnlxfa+> z|M6%&ZXBi)jnB~F1DP;O)nkV_9hzLD_Bu;0mupKK&X?KkituByMsD~g%Rez>2cxud zwMr{RZ8VaT$Ns`oDkRrdA*Glsn4c2;*Q&68FkQ9Z$;5>PVdH`TWVH-Lg9m}=dWXGq z9B&rQ(V+JS4K{bz!d=K2jLpT~rUs1OnFEVw20Ru6{$SSg;Qh>2G$_=I9L&@jo~5g1 zk}bH){`iZ@ViTP#O~^C;Rlw}deTg!5kVc{xtMKv^^QNb&pdP0}&N=ezI(t+MCF?Md zJ?%RKvGx%A6ggghnoaIuJe{;@T2ww~AK`2*R<9;+N#-E?qyZDi$VK)sVD)ALT@tyN zP@Ic-%uoL5&A#_Ug}Q^cnfd^|Tb|6!w5^#eNzCbVd7+`_kB-K*%(k$Mmkq3WDF5>f zdO2ckA$u&JaGtBdyyp_KohkG&HV#6@D7vI}1R`%~AY6arp8T5@rCA);pR;eVDL>m` zEjraP!0JX0mT^qA=)$~%6S+Jmp*N`;U6BVA>QW7Jo<}gZlZ?v6(PnDr2T8K!c#1gC z1GeifKMUPo+nrLSTYdJIrZU5VETf!bmgzrTQ17@BBAvDHeqGx4H4#$44O8i`ES$VGb5?%i=fljZgZYp+CDi3&r>fNuQ| zh!LEFZ8#SnUlE8uKL(com=O&fR`xpaV zA)HI@(2bv9)FrlCD}@Ur9xfN*-Y&->y#AqN|Zo)CEQIKDXW<%zL6UFP0Jcn zA9|dt+2imlB?kSfL{2Le`p*c$x2J)a9~ubH1_7w;69|=65Dc!&)=;tEfKJan%gLqK zlCNCPet@?I*w!+j*Ec#V`FUEPE*=90JneY85Jq|P|LOR#L z_um)5n|sSnYYNd+$YR1=3e^M5%SaAr!I*s!m;6;zZ!hRIy>q3$zEE2c9g<3-DO9E z-qORri~JR-z=SIbx&X*DZdc&I0)DQm3iP$|f_^AJ2j{L|!kJ&3=??#|^yzcoq&fhVTb zqLVR%{iS&xnAC6*qBwV*`N{mxap5p8q4WL#uhn(t8*)xJ>z0X+LF6m>&mZU6yReqr z`QReFp2of@&SAHovuBDuR9kJyq6T-BX=7C4b=E;f`1F(-t8HXVGe`E7SBD3x;csSx zA6Q|AR*TGV@Od@V;~sS1HV;%+dm`tm2mZZCmT-nARt^qFx3Szex`$z+MK~s&V_zJ3 z)CqMnv27?_zB}}oevb8#0zI}Bb8l9`9?5fs_|$`Sg^WVjb)bKFD*cSryGaX=E)u45 z6zO0mbFV7pX-)PU|6!8Sbw;sfy{pwe_VdOX#lS2Dmt0Sn|HdA{treY`#+!?C&sGs|n~@#4517i+Ok?tmUieKWCwpRLBbLiEVwzV2Wl z0QR)yvVUP5uUYpLX>OG$JsxXic#uY>o{N`X_oawW8SBWLC*+a}Z(led;krFt4oXD! z3qnMTAS_goq2@b3c5x8Cer26FgEdypTb8f2_)PDMYYcnJxi0oGvOi~C4)mMJr1i^% zc~%b27BT0UoZj^qh1&3t%<_E`_mXC6S7s`2*qKOvIzjquO%lI#$)ao>FLPKoAGnog ztx6TP=5o*SL50Eh9Z^1BiRnQB+=BL+B`Ub#rWB_(?|4T7=~)U$STj{Pl3 zMm*69GqA+%Sd#QVn8;i*tz6&hfRNYh3#j1UYAmnQXFIfAt;C&QgRuJmJ&^%q81InT z1LyfHj@6D@6#mqr!vrmQ$I|Kkl>3rxNoc;!z+S8zSo5E8uUIoK%f({ypWiCTo7083 z;G04nd`O|zJW;4KACW2ioFpDONz!HZDM@XYET^NAq_TdpqzrSw-JvS1w@@LE=L$c| z>C)}tz#K9<2jjSZ;vQ{udLT*z1Mwm}2)4g#@!U;|9sEk2lLWiANm%qvgRu(kUFMLd zTw_4kW4hpbaZY8Q{kVk+bus-xy{nt4eYwtX{Hai)aIw8 z`MVVP(998%2n6G5t*aic$iwziJ&-tqn`~AlmkQiWq8GXyKrxa>svO-<9m|ovA3UvbK z_?u@E#r#T=MAJv{&@5Sc=f=vx1xeDOM^{Yb^BZi=41?=R`2Ix~gtrQF`UIivSgv`h zabL@G2+N`X4CX#m-+-A+g&G`vNG|`a1~a%mn^Zt9wnh%>{KNd~Xl6_Y(7${>2k-V7 z@E7OuK=uZ#B8O^|&;QLizUm$S`G5M#7Cmn*_7&waVuTw`HVDNDwGIa&3g{?qCD)ez zkf(tzm~P2hFnO-Y|B@@LYc78=hp1W<^MxPKi+4N&Jx7o?iEbo0&de8X=8CbAA!J`O zaC;v6v(?RIZQJiMYqC2ED?_nlw+_~!1yCMpB^}j2rA0&XJAVYjvXLHBg2^RqvXqxe z6%s#^yxW;z6fM=^tu7z?+gQrR=H;UL;DT~Z2u>NvLv7DTMvFG`g88r?tlhD5YzT6X zq$BG&y<->2VKF<&a=Hq!Q3(09z zB4NzoJuoce||B!o)w{Zl*pXu0r{A@ubo)d{V9Q?-B3qIo@>Z| zc_aB~f7(KpEGw0+aV~Uev5$BP^II3^BmFtKysKpr)R7*{k>n!l>oD#*J$H!>rN@zP zGStTv_lI-un5V-$a#(F=TgkVRrF1>g)7LD7``rv2<8>aHMGh#aLi&}v0)3b-Jd=LC zsQ|nM@z(ieTo|4zkeUeTxFjENLeT&VQFVyl&6UL!g?Q0q@uOSZ&`*Iu9-r zgP!+yZWxvXWx#wHIacrXqT5j^*QU_-Ff0U$_UzvxzxF8JLUu)zNbxZ~hi^l0X@5GN zEg_$k+C+-7OJuph1?`JMaFw-7wH@!TzP&h1E|;e*-SA^}DBh97ayZKSmEM9GVL#=8 zxMGe)DB>!0C>>USX!;h-pH)ixTJ%-FBe(040ayP1?|)fJ{nmUh_<7uHLa{iPT%J=t z4)wE;9hK#xadE|XK8H?&=-KQ+FXXOvQnvPo_%a84RCU&CU+It?mXEY|%_M~U;Q56v z5Z=e9yuZ&j@OiLmD?WcPHz3socdCN1^q~%p6?x1MpvRLr@2Y(Mp4lNlFu6;I0z6&Y zLh5uV72O9n%#0?Nx`!1X3xFTZ% z{eyfCTb$0v)B7D{pl6wc@V)a42*J%T9o;G9XX`hYYOl&<8M)56iHT!)fc`LJkW zA>a4?l;cZW*%uswu1Y?K76nL2wGe~%cTs$!kCohavspUyO=E6*{T5Q$ieAwHE*QZ3 zHK1Dt8u2;#`pimBxK&6QbFuX!L-5ujgSo&3xX4`fho0Z%Qw=wGKMg@oa^-0?3-Gpc zGx=n!l;~|PxXE!TEmnsNa+JSaYfBGysf7IMib8UW4?B=6pH83b*iJI`LaF#H8;6rK zLNSz_=E)j719)~qru*Ar@2d@H=a`7ef%NE2GU4FESb0=rjn-#;;Ow4={+`Th&LU5@ zHd5{_vO%99AFd@5(6b#KJ>>rU_eDuI`KBw|0}&dZh;a$oP`oi>L&OPb{mmY$-;m2= zO?HfT7B21~514yGjt{iO8s?b}dY6Dfi?b1Nk(}L}IH~EuTwQW`_y3AV6LM!~4w|r| zUbLjA*kPQjAN#`-Vc8)Y!Do#~nHVW5yduZLtrsdnBS(em1ipjr7YzNl!}~^e|(d^5uB^z9$>Qt{GAB zYmBT2vBu0dKDb|*fZxwQ#5?kaj-~O^ z9C@xWEy*R#GGcgmtUQjl#l|{*So1Ie`+AcznruXmFDGT_7v^8jA=h&-0aq?$VIV)x zP48oJ|FjK8P4ht+xzSNKbKpTfD`z|NyZ4bdyvbbMA@pYYXW`Hh6FR%c$mh@2^c4DI zbO?J4BeM|9>pbvYv@F=h`+Lt1e|od#{UjTg_Lx|kkCA(scDQ?B12RGq@xYC|LVFYL zS;a^n7hCk1v;ptVCh(jm3tPLN_-pTqQ%)kCCM#9Riah>M? zD|{2sdVLl;yfWhBwP@)|o^<Ybw8KeRLbunWRGvFnC!*$tEGRyZ zd&-KHLvNWAO>U&eUkUiUnf&QE6VmEOi4F6VBZiVMo1K7vR%bEm*8~r8ZSKtJzOdE@ zwO1#gY%;x&{BzGFMN0v>zp_()XwokcK7RC1)ns3=f&5^o4bM(|@R*!b5qY#b+nB#R zGD=E%vX^ra^K*-t4a&dQkLyNQ^d+Zx$QC;m`XN3#f%~K!JRV@g_c~FM;bI5x&i+`$ z>lwI+Tw9J2-c#eGjDPOC{0(@0Gy#EmS?m#IZuR;Y+4jN)2J&AIxqmv?HwTJcMs$)` z8A@*SSdkBVM-otDeGX=?Gor)2C>fSwgJXkykvKIG?!J7^la1KZ>$ps!7xLaLKinM2 z=Qfet-$WC(I7N!jB0Dth=8qC`m&xS&tfI+#21LrY-)%6kg+D(1O5dn18|$B$aEhML zPxL}Q*hSysjRagP&qCwlCcKywCGY9WdvMAZ6IJAJBgujCd2<>RCy&nAqEYY$JpUts zPM0iP{l$c3+DNIk+ZKDmeKF0FT%dVMW zlB1lH>WkD93Cxt`bIa$g7yIqPnRo2;m3hs)?{n^v=lyQN(LbZ*G(Cgvdwkj3oQOT- z?0&R0K|4KG_8M%+j_~^LOhCJJ~esvegDX&-uX1kbwLHe6I4C zul+butnS(%uFxMotrF3b?{9;P^j#X`Wbj+wuUKE`cpYk!v!2nCwZ;e0;>PjZa{LAq z%}>Pkt64bw$%wS%XsK&qi~5QFP~Ru#+lKkS_UN_Hhpy~+j!juGe{94vn^^hT(iUc~{or#V5g)r}ntimestep != update->beginstep){ fdrag[0] = gamma1*gjffac*v[i][0]; fdrag[1] = gamma1*gjffac*v[i][1]; fdrag[2] = gamma1*gjffac*v[i][2]; } + else if (Tp_GJF && update->ntimestep == update->beginstep){ + fdrag[0] = 0.0; + fdrag[1] = 0.0; + fdrag[2] = 0.0; + } flangevin[i][0] = fdrag[0] + fran[0]; flangevin[i][1] = fdrag[1] + fran[1]; flangevin[i][2] = fdrag[2] + fran[2]; From 3ae8d5ea702eae92d1645608b2e75abcb119fcc6 Mon Sep 17 00:00:00 2001 From: casievers Date: Tue, 23 Jul 2019 18:41:31 -0700 Subject: [PATCH 073/557] debugging gjf tally --- src/fix_langevin.cpp | 26 +++++++++++++------------- 1 file changed, 13 insertions(+), 13 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 3aa8a8e6ff..33f5c3d2d9 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -660,9 +660,12 @@ void FixLangevin::post_force_templated() if (Tp_TALLY) { if (Tp_GJF && update->ntimestep != update->beginstep){ - fdrag[0] = gamma1*gjffac*v[i][0]; - fdrag[1] = gamma1*gjffac*v[i][1]; - fdrag[2] = gamma1*gjffac*v[i][2]; + fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; + fran[0] *= gjffac; + fran[1] *= gjffac; + fran[2] *= gjffac; } else if (Tp_GJF && update->ntimestep == update->beginstep){ fdrag[0] = 0.0; @@ -894,14 +897,8 @@ void FixLangevin::end_of_step() v[i][2] = lv[i][2]; } } - if (tallyflag && hsflag){ - energy_onestep += gjffac*(flangevin[i][0] * lv[i][0] + - flangevin[i][1] * lv[i][1] + flangevin[i][2] * lv[i][2]); - } - else if (tallyflag){ - energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + - flangevin[i][2] * v[i][2]; - } + energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + + flangevin[i][2] * v[i][2]; } if (tallyflag) { energy += energy_onestep * update->dt; @@ -977,8 +974,11 @@ double FixLangevin::compute_scalar() } // convert midstep energy back to previous fullstep energy - - double energy_me = energy - 0.5*energy_onestep*update->dt; + double energy_me; + if (gjfflag) + energy_me = energy - energy_onestep*update->dt; + else + energy_me = energy - 0.5*energy_onestep*update->dt; double energy_all; MPI_Allreduce(&energy_me,&energy_all,1,MPI_DOUBLE,MPI_SUM,world); From b97e856bf29d87059a8236230ff5591af2748838 Mon Sep 17 00:00:00 2001 From: casievers Date: Wed, 24 Jul 2019 16:05:25 -0700 Subject: [PATCH 074/557] Tally works and example readmes addes --- examples/gjf/README.md | 13 +++++++++++++ examples/python/gjf_python/README.md | 18 ++++++++++++++++++ src/fix_langevin.cpp | 5 ----- 3 files changed, 31 insertions(+), 5 deletions(-) create mode 100644 examples/gjf/README.md create mode 100644 examples/python/gjf_python/README.md diff --git a/examples/gjf/README.md b/examples/gjf/README.md new file mode 100644 index 0000000000..e285ab8510 --- /dev/null +++ b/examples/gjf/README.md @@ -0,0 +1,13 @@ +# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON + +## GJF-2GJ THERMOSTAT + +This directory contains the ingredients to run an NVT simulation using the GJF-2GJ thermostat. + +Example: +``` +NP=4 #number of processors +mpirun -np $NP lmp_mpi -in.argon -out.argon +``` + +## Required LAMMPS packages: MOLECULE package diff --git a/examples/python/gjf_python/README.md b/examples/python/gjf_python/README.md new file mode 100644 index 0000000000..707289f02d --- /dev/null +++ b/examples/python/gjf_python/README.md @@ -0,0 +1,18 @@ +# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON + +## GJF-2GJ THERMOSTAT + +This directory contains a python script to run NVT simulations using the GJF-2GJ thermostat. +The script will vary the timestep and write thermodynamic output to screen. +This script has True/False options to change how you would like to dump/write your output. + +Example: +``` +NP=4 #number of processors +mpirun -np $NP python gjf.py +``` + +## Required LAMMPS packages: MOLECULE package +## LAMMPS COMPILE MODE: SHLIB +## LAMMPS OPTIONAL INSTALL: make install-python +## Required Python packages: mpi4py diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 33f5c3d2d9..bfd170262e 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -174,11 +174,6 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { - //int mem = 6*atom->nmax*sizeof(double); - //if (hsflag) mem += 3*atom->nmax*sizeof(double); -// - //comm->maxexchange_fix = MAX(comm->maxexchange_fix, 0); - //comm->maxexchange_fix += MAX(1000, mem); nvalues = 3; grow_arrays(atom->nmax); From 13f4fe186be64b10ed387f716dcf6cfb91a904c7 Mon Sep 17 00:00:00 2001 From: casievers Date: Wed, 24 Jul 2019 16:30:02 -0700 Subject: [PATCH 075/557] Updated examples/gjf/README.md --- examples/gjf/README.md | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/examples/gjf/README.md b/examples/gjf/README.md index e285ab8510..79ef4cd2e1 100644 --- a/examples/gjf/README.md +++ b/examples/gjf/README.md @@ -1,4 +1,4 @@ -# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON +# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE ## GJF-2GJ THERMOSTAT From 14d38596050af99f9b3bbeef49bf229b18031b41 Mon Sep 17 00:00:00 2001 From: casievers Date: Wed, 24 Jul 2019 20:08:00 -0700 Subject: [PATCH 076/557] Added GJF-2GJ authors --- src/fix_langevin.cpp | 2 ++ 1 file changed, 2 insertions(+) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index bfd170262e..ea0929a236 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -14,6 +14,8 @@ /* ---------------------------------------------------------------------- Contributing authors: Carolyn Phillips (U Mich), reservoir energy tally Aidan Thompson (SNL) GJF formulation + Charles Sievers (UC Davis) GJF-2GJ Implementation + Niels Gronbech-Jensen (UC Davis) GJF-2GJ Formulation ------------------------------------------------------------------------- */ #include From cc96ea1ded97f45f394bc9abec28b5e649a3368b Mon Sep 17 00:00:00 2001 From: casievers Date: Thu, 25 Jul 2019 15:23:01 -0700 Subject: [PATCH 077/557] added respa compatability, and simplified examples --- .gitignore | 3 + examples/gjf/README.md | 2 +- examples/gjf/in.argon | 162 -------------------------------------- examples/gjf/in.gjf.vfull | 23 ++++++ examples/gjf/in.gjf.vhalf | 23 ++++++ 5 files changed, 50 insertions(+), 163 deletions(-) delete mode 100644 examples/gjf/in.argon create mode 100644 examples/gjf/in.gjf.vfull create mode 100644 examples/gjf/in.gjf.vhalf diff --git a/.gitignore b/.gitignore index f9dda49da6..3e4ebcda98 100644 --- a/.gitignore +++ b/.gitignore @@ -43,3 +43,6 @@ Thumbs.db /Makefile /cmake_install.cmake /lmp + +#python example +/example/python/gjf_python diff --git a/examples/gjf/README.md b/examples/gjf/README.md index 79ef4cd2e1..e6886cb2dd 100644 --- a/examples/gjf/README.md +++ b/examples/gjf/README.md @@ -7,7 +7,7 @@ This directory contains the ingredients to run an NVT simulation using the GJF-2 Example: ``` NP=4 #number of processors -mpirun -np $NP lmp_mpi -in.argon -out.argon +mpirun -np $NP lmp_mpi -in.gjf.vhalf ``` ## Required LAMMPS packages: MOLECULE package diff --git a/examples/gjf/in.argon b/examples/gjf/in.argon deleted file mode 100644 index 271882c665..0000000000 --- a/examples/gjf/in.argon +++ /dev/null @@ -1,162 +0,0 @@ -###############################mm -# Atom style - charge/vdw/bonded# -################################# -atom_style full - -############################################## -#Units Metal : eV - ps - angstrom - bar# -# Real : kcal/mol - fs - angstrom - atm# -############################################## -units metal - -############ -#Run number# -############ -variable run_no equal 0 # is it a restart? -variable res_no equal ${run_no}-1 # restart file number - -####################################### -#Random Seeds and Domain Decomposition# -####################################### -variable iseed0 equal 2357 -variable iseed1 equal 26488 -variable iseed2 equal 10669 -processors * * * - -########### -#Data File# -########### -variable inpfile string argon.lmp -variable resfile string final_restart.${res_no} -variable ff_file string ff-argon.lmp - -########## -#Run Type# -########## -variable minimise equal 0 #Energy Minimization -variable md equal 1 #Plain MD - -############################### -#Molecular Dynamics Parameters# -############################### -variable run_no equal 0 # is it a restart? - -variable ens equal 9 # ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres, 7=stoch, 8=gjf) -variable ts equal 0.120 # simulation timestep (time units) -variable nequil equal 0 # number of equilibration steps -variable nsteps equal 200000 # number of MD steps -#variable nsteps equal 20 # number of MD steps - -variable temp_s equal 10 # starting temperature -variable temp_f equal 10 # final simulation temperature -variable trel equal 1 # thermostat relaxation time -variable tscale equal 1 # thermostat relaxation freq - vel rescaling only -variable deltat equal 1 # maximum temperature change - vel rescaling only - -variable npttype string iso # type of NPT (iso, aniso, tri, z...) -variable pres equal 1.01325 # pressure (NPT runs only) -variable prel equal 1.0 # barostat relaxation time - -neighbor 1 bin - -################### -#Output Parameters# -################### -variable ntraj equal 1000 # trajectory output frequency - all system -variable ntraj_s equal -100 # trajectory output frequency - solute only -variable nthermo equal 200 # thermodynamic data output frequency - -################################ -#Energy Minimization Parameters# -################################ -variable mtraj equal 1 # trajectory output frequency - all system -variable etol equal 1e-5 # % change in energy -variable ftol equal 1e-5 # max force threshold (force units) -variable maxiter equal 10000 # max # of iterations - -######################## -#3D Periodic Simulation# -######################## -boundary p p p - -############################# -#Reading the input structure# -############################# -if "${run_no} == 0" then "read_data ${inpfile}" else "read_restart ${resfile}" - -############# -#Force Field# -############# -include ${ff_file} - -###################### -#Thermodynamic Output# -###################### -variable str_basic string 'step time pe temp press' - -#MD ensemble (0=nve, 1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres) -variable str_ens string ' ' -if "${ens} == 0" then "variable str_ens string 'etotal'" -if "${ens} == 2" then "variable str_ens string 'vol pxx pyy pzz cella cellb cellc cellakpha cellbeta cellgamma'" - -#Variable for a gulp friend output -if "${ens} >= 0" then "thermo_style custom time temp pe etotal press vol cpu" & - "thermo ${nthermo}" & - "thermo_modify flush yes" - -##################### -#Energy Minimization# -##################### -if "${minimise} <= 0 || ${run_no} > 0" then "jump SELF end_minimise" - print "Doing CG minimisation" - dump mdcd all dcd ${mtraj} min.dcd - dump_modify mdcd unwrap yes - min_style cg - min_modify line quadratic - minimize ${etol} ${ftol} ${maxiter} ${maxiter} - reset_timestep 0 - undump mdcd -label end_minimise - -################ -#Timestep in ps# -################ -timestep ${ts} - -############## -#Restart file# -############## -restart 100000 restart.1 restart.2 - -################### -#Trajectory output# -################### -#dump xyz all atom 1000 silicon.lammpstrj - -if "${ntraj} > 0" then & - "dump 1 all dcd ${ntraj} trajectory.${run_no}.dcd" & - "dump_modify 1 unwrap yes" - -fix mom all momentum 1 linear 1 1 1 - -############################################################### -#Ensembles (0=nve,1=nvt, 2=npt, 3=ber, 4=lang, 5=stoc, 6=vres)# -############################################################### -if "${md} > 0" then 'print "Setting up the ensembles"' & - 'if "${run_no} == 0" then "velocity all create ${temp_s} ${iseed0} mom yes dist gaussian"' & - 'if "${ens} == 0" then "fix nve all nve"' & - 'if "${ens} == 1" then "fix nvt all nvt temp ${temp_s} ${temp_f} ${trel} tchain 5"' & - 'if "${ens} == 2" then "fix npt all npt temp ${temp_s} ${temp_f} ${trel} ${npttype} ${pres} ${pres} ${prel} tchain 5 pchain 5 mtk yes"' & - 'if "${ens} == 3" then "fix nve all nve" "fix ber all temp/berendsen ${temp_s} ${temp_f} ${trel}"' & - 'if "${ens} == 4" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} tally yes zero yes"' & - 'if "${ens} == 5" then "fix nve all nve" "fix stoch all temp/csvr ${temp_s} ${temp_f} ${trel} ${iseed1}"' & - 'if "${ens} == 6" then "fix nve all nve" "fix stoch all temp/csld ${temp_s} ${temp_f} ${trel} ${iseed1}"' & - 'if "${ens} == 7" then "fix nve all nve" "fix vres all temp/rescale ${tscale} ${temp_s} ${temp_f} ${tmin} ${tmax}"' & - 'if "${ens} == 8" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes"' & - 'if "${ens} == 9" then "fix nve all nve" "fix lang all langevin ${temp_s} ${temp_f} ${trel} ${iseed1} gjf yes halfstep yes"' - -if "${md} > 0" then "print 'Doing Molecular dynamics'" & - "run ${nsteps}" & - "write_restart final_restart.${run_no}" - - diff --git a/examples/gjf/in.gjf.vfull b/examples/gjf/in.gjf.vfull new file mode 100644 index 0000000000..19420e22ca --- /dev/null +++ b/examples/gjf/in.gjf.vfull @@ -0,0 +1,23 @@ +# GJF-2GJ thermostat + +units metal +atom_style full + +boundary p p p +read_data argon.lmp + +include ff-argon.lmp + +velocity all create 10 2357 mom yes dist gaussian + +neighbor 1 bin + +timestep 0.1 + +fix nve all nve +fix lang all langevin 10 10 1 26488 gjf vfull + +thermo 200 +run 50000 + + diff --git a/examples/gjf/in.gjf.vhalf b/examples/gjf/in.gjf.vhalf new file mode 100644 index 0000000000..74e2089595 --- /dev/null +++ b/examples/gjf/in.gjf.vhalf @@ -0,0 +1,23 @@ +# GJF-2GJ thermostat + +units metal +atom_style full + +boundary p p p +read_data argon.lmp + +include ff-argon.lmp + +velocity all create 10 2357 mom yes dist gaussian + +neighbor 1 bin + +timestep 0.1 + +fix nve all nve +fix lang all langevin 10 10 1 26488 gjf vhalf + +thermo 200 +run 50000 + + From 883f6d1e8d6eb18e7ab520a1a7845ec41f31607a Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 26 Jul 2019 09:06:43 -0600 Subject: [PATCH 078/557] Commit1 JT 072619 - corrected warnings in cg and lbfgs - removed unused variables in spin/dipole pair styles --- src/SPIN/min_spin_oso_cg.cpp | 6 ++++-- src/SPIN/min_spin_oso_lbfgs.cpp | 12 ++++++------ src/SPIN/min_spin_oso_lbfgs.h | 20 ++++++++++---------- src/SPIN/pair_spin_dipole_cut.cpp | 2 +- src/SPIN/pair_spin_dipole_long.cpp | 5 +---- 5 files changed, 22 insertions(+), 23 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 2bdc00d8ed..1c91fa1500 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -512,7 +512,8 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ - out[i] *= 0.0; + //out[i] *= 0.0; + out[i] = 0.0; for(int j = 0; j < 3; j++) out[i] += *(m + 3 * j + i) * v[j]; } @@ -627,7 +628,8 @@ int MinSpinOSO_CG::awc(double der_phi_0, double phi_0, double der_phi_j, double double sigma = 0.9; if ((phi_j<=phi_0+eps*fabs(phi_0)) && - ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + ((2.0*delta-1.0) * der_phi_0>=der_phi_j) && + (der_phi_j>=sigma*der_phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index 6aaeb7ca23..b9315d706e 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -63,7 +63,7 @@ static const char cite_minstyle_spin_oso_lbfgs[] = /* ---------------------------------------------------------------------- */ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : - Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), ds(NULL), dy(NULL), rho(NULL), sp_copy(NULL) + Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), rho(NULL), ds(NULL), dy(NULL), sp_copy(NULL) { if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); nlocal_max = 0; @@ -345,7 +345,6 @@ void MinSpinOSO_LBFGS::calc_search_direction() double sq_global = 0.0; double yy_global = 0.0; double yr_global = 0.0; - double beta_global = 0.0; int m_index = local_iter % num_mem; // memory index int c_ind = 0; @@ -520,8 +519,6 @@ void MinSpinOSO_LBFGS::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; - double **fm = atom->fm; - double tdampx, tdampy, tdampz; double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; @@ -648,7 +645,8 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ - out[i] *= 0.0; + //out[i] *= 0.0; + out[i] = 0.0; for(int j = 0; j < 3; j++) out[i] += *(m + 3 * j + i) * v[j]; } @@ -762,7 +760,9 @@ int MinSpinOSO_LBFGS::awc(double der_phi_0, double phi_0, double der_phi_j, doub double delta = 0.1; double sigma = 0.9; - if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j>=sigma*der_phi_0)) + if ((phi_j<=phi_0+eps*fabs(phi_0)) && + ((2.0*delta-1.0) * der_phi_0>=der_phi_j) && + (der_phi_j>=sigma*der_phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 3071bacc35..204f6bf058 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -34,14 +34,13 @@ class MinSpinOSO_LBFGS: public Min { void reset_vectors(); int iterate(int); private: - int ireplica,nreplica; // for neb + int ireplica,nreplica; // for neb double *spvec; // variables for atomic dof, as 1d vector double *fmvec; // variables for atomic dof, as 1d vector - double *g_cur; // current gradient vector - double *g_old; // gradient vector at previous step + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector double *p_s; // search direction vector - double **sp_copy; // copy of the spins - int local_iter; // for neb + int local_iter; // for neb int nlocal_max; // max value of nlocal (for size of lists) void advance_spins(); @@ -54,14 +53,15 @@ class MinSpinOSO_LBFGS: public Min { int awc(double, double, double, double); void make_step(double, double *); double max_torque(); - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - int use_line_search; // use line search or not. + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + int use_line_search; // use line search or not. double maxepsrot; - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg double *rho; // estimation of curvature + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double **sp_copy; // copy of the spins int num_mem; // number of stored steps bigint last_negative; }; diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index 4ff198488a..e6b9a59ad9 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -323,7 +323,7 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) { int j,jnum,itype,jtype,ntypes; - int *ilist,*jlist,*numneigh,**firstneigh; + int *jlist,*numneigh,**firstneigh; double rsq,rinv,r2inv,r3inv,local_cut2; double xi[3],rij[3],eij[3],spi[4],spj[4]; diff --git a/src/SPIN/pair_spin_dipole_long.cpp b/src/SPIN/pair_spin_dipole_long.cpp index e3575a6a07..febc6f924c 100644 --- a/src/SPIN/pair_spin_dipole_long.cpp +++ b/src/SPIN/pair_spin_dipole_long.cpp @@ -355,10 +355,9 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) { - //int i,j,jj,jnum,itype,jtype; int j,jj,jnum,itype,jtype,ntypes; int k,locflag; - int *ilist,*jlist,*numneigh,**firstneigh; + int *jlist,*numneigh,**firstneigh; double r,rinv,r2inv,rsq,grij,expm2,t,erfc; double local_cut2,pre1,pre2,pre3; double bij[4],xi[3],rij[3],eij[3],spi[4],spj[4]; @@ -368,7 +367,6 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) double **sp = atom->sp; double **fm_long = atom->fm_long; - ilist = list->ilist; numneigh = list->numneigh; firstneigh = list->firstneigh; @@ -406,7 +404,6 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) // computation of the exchange interaction // loop over neighbors of atom i - //i = ilist[ii]; xi[0] = x[ii][0]; xi[1] = x[ii][1]; xi[2] = x[ii][2]; From 7e5c293a233b7f8e5b7095559452b92fb4c7eddd Mon Sep 17 00:00:00 2001 From: alxvov Date: Fri, 26 Jul 2019 16:30:38 +0000 Subject: [PATCH 079/557] delete comment. Add line option --- src/SPIN/min_spin_oso_cg.cpp | 1 - src/SPIN/min_spin_oso_lbfgs.cpp | 3 +-- src/min.cpp | 2 ++ 3 files changed, 3 insertions(+), 3 deletions(-) diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 1c91fa1500..f95bffb947 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -512,7 +512,6 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ - //out[i] *= 0.0; out[i] = 0.0; for(int j = 0; j < 3; j++) out[i] += *(m + 3 * j + i) * v[j]; diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index b9315d706e..ce459586bf 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -645,7 +645,6 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ - //out[i] *= 0.0; out[i] = 0.0; for(int j = 0; j < 3; j++) out[i] += *(m + 3 * j + i) * v[j]; @@ -760,7 +759,7 @@ int MinSpinOSO_LBFGS::awc(double der_phi_0, double phi_0, double der_phi_j, doub double delta = 0.1; double sigma = 0.9; - if ((phi_j<=phi_0+eps*fabs(phi_0)) && + if ((phi_j<=phi_0+eps*fabs(phi_0)) && ((2.0*delta-1.0) * der_phi_0>=der_phi_j) && (der_phi_j>=sigma*der_phi_0)) return 1; diff --git a/src/min.cpp b/src/min.cpp index 2a42a444a0..a903fa98d8 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -653,6 +653,8 @@ void Min::modify_params(int narg, char **arg) if (strcmp(arg[iarg+1],"backtrack") == 0) linestyle = 0; else if (strcmp(arg[iarg+1],"quadratic") == 0) linestyle = 1; else if (strcmp(arg[iarg+1],"forcezero") == 0) linestyle = 2; + else if (strcmp(arg[iarg+1],"spin_cubic") == 0) linestyle = 3; + else if (strcmp(arg[iarg+1],"spin_none") == 0) linestyle = 4; else error->all(FLERR,"Illegal min_modify command"); iarg += 2; } else { From c5b7a36eebe3f8a886c902d53d71486920ecea2d Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 26 Jul 2019 17:33:49 -0600 Subject: [PATCH 080/557] Commit JT 072619 - added a min_style option for norm type (euclidean or Max) - adapted and tested spin minimizers - adapted (net tested) regular minimizers --- src/SPIN/min_spin.cpp | 90 +++++-------------------------- src/SPIN/min_spin.h | 2 - src/SPIN/min_spin_oso_cg.cpp | 94 +++++++++++++-------------------- src/SPIN/min_spin_oso_cg.h | 72 ++++++++++++------------- src/SPIN/min_spin_oso_lbfgs.cpp | 61 ++++++++------------- src/SPIN/min_spin_oso_lbfgs.h | 74 +++++++++++++------------- src/min.cpp | 74 ++++++++++++++++++++++++++ src/min.h | 14 +++-- src/min_cg.cpp | 12 ++++- src/min_fire.cpp | 12 ++++- src/min_hftn.cpp | 4 ++ src/min_quickmin.cpp | 12 ++++- src/min_sd.cpp | 3 +- 13 files changed, 266 insertions(+), 258 deletions(-) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index f56c9f0d96..d229927c29 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -119,7 +119,7 @@ void MinSpin::reset_vectors() int MinSpin::iterate(int maxiter) { bigint ntimestep; - double fmdotfm; + double fmdotfm,fmsq,fmsqall; int flag,flagall; for (int iter = 0; iter < maxiter; iter++) { @@ -166,8 +166,20 @@ int MinSpin::iterate(int maxiter) // magnetic torque tolerance criterion // sync across replicas if running multi-replica minimization + fmdotfm = fmsq = fmsqall = 0.0; if (update->ftol > 0.0) { - fmdotfm = max_torque(); + if (normstyle == 1) { // max torque norm + fmsq = max_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_MAX,universe->uworld); + } else { // Euclidean torque norm + fmsq = total_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_SUM,universe->uworld); + } + fmdotfm = fmsqall*fmsqall; if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -297,77 +309,3 @@ void MinSpin::advance_spins(double dts) // because no need for simplecticity } } - -/* ---------------------------------------------------------------------- - compute and return ||mag. torque||_2^2 -------------------------------------------------------------------------- */ - -double MinSpin::fmnorm_sqr() -{ - int nlocal = atom->nlocal; - double tx,ty,tz; - double **sp = atom->sp; - double **fm = atom->fm; - - // calc. magnetic torques - - double local_norm2_sqr = 0.0; - for (int i = 0; i < nlocal; i++) { - tx = (fm[i][1]*sp[i][2] - fm[i][2]*sp[i][1]); - ty = (fm[i][2]*sp[i][0] - fm[i][0]*sp[i][2]); - tz = (fm[i][0]*sp[i][1] - fm[i][1]*sp[i][0]); - - local_norm2_sqr += tx*tx + ty*ty + tz*tz; - } - - // no extra atom calc. for spins - - if (nextra_atom) - error->all(FLERR,"extra atom option not available yet"); - - double norm2_sqr = 0.0; - MPI_Allreduce(&local_norm2_sqr,&norm2_sqr,1,MPI_DOUBLE,MPI_SUM,world); - - return norm2_sqr; -} - -/* ---------------------------------------------------------------------- - compute and return max_i||mag. torque_i||_2 -------------------------------------------------------------------------- */ - -double MinSpin::max_torque() -{ - double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double hbar = force->hplanck/MY_2PI; - double tx,ty,tz; - double **sp = atom->sp; - double **fm = atom->fm; - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - tx = fm[i][1] * sp[i][2] - fm[i][2] * sp[i][1]; - ty = fm[i][2] * sp[i][0] - fm[i][0] * sp[i][2]; - tz = fm[i][0] * sp[i][1] - fm[i][1] * sp[i][0]; - fmsq = tx * tx + ty * ty + tz * tz; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - // multiply it by hbar so that units are in eV - - return sqrt(fmaxsqall) * hbar; -} diff --git a/src/SPIN/min_spin.h b/src/SPIN/min_spin.h index d6d49203d5..f2df81e58c 100644 --- a/src/SPIN/min_spin.h +++ b/src/SPIN/min_spin.h @@ -35,8 +35,6 @@ class MinSpin : public Min { int iterate(int); double evaluate_dt(); void advance_spins(double); - double fmnorm_sqr(); - double max_torque(); private: diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 1c91fa1500..16a95c5c02 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -29,6 +29,7 @@ #include "universe.h" #include "atom.h" #include "citeme.h" +#include "comm.h" #include "force.h" #include "update.h" #include "output.h" @@ -99,6 +100,13 @@ void MinSpinOSO_CG::init() Min::init(); + // warning if line_search combined to gneb + + if ((nreplica >= 1) && (linestyle != 4) && (comm->me == 0)) + error->warning(FLERR,"Line search incompatible gneb"); + + // set back use_line_search to 0 if more than one replica + if (linestyle == 3 && nreplica == 1){ use_line_search = 1; } @@ -175,7 +183,7 @@ int MinSpinOSO_CG::iterate(int maxiter) { int nlocal = atom->nlocal; bigint ntimestep; - double fmdotfm; + double fmdotfm,fmsq,fmsqall; int flag, flagall; double **sp = atom->sp; double der_e_cur_tmp = 0.0; @@ -261,8 +269,20 @@ int MinSpinOSO_CG::iterate(int maxiter) // magnetic torque tolerance criterion // sync across replicas if running multi-replica minimization + fmdotfm = fmsq = fmsqall = 0.0; if (update->ftol > 0.0) { - fmdotfm = max_torque(); + if (normstyle == 1) { // max torque norm + fmsq = max_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_MAX,universe->uworld); + } else { // Euclidean torque norm + fmsq = total_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_SUM,universe->uworld); + } + fmdotfm = fmsqall*fmsqall; if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -353,6 +373,7 @@ void MinSpinOSO_CG::calc_search_direction() MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); // Sum over all replicas. Good for GNEB. + if (nreplica > 1) { g2 = g2_global * factor; g2old = g2old_global * factor; @@ -361,7 +382,9 @@ void MinSpinOSO_CG::calc_search_direction() } if (fabs(g2_global) < 1.0e-60) beta = 0.0; else beta = g2_global / g2old_global; + // calculate conjugate direction + for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = (beta * p_s[i] - g_cur[i]) * factor; g_old[i] = g_cur[i] * factor; @@ -379,7 +402,7 @@ void MinSpinOSO_CG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; - double rot_mat[9]; // exponential of matrix made of search direction + double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; // loop on all spins on proc. @@ -394,47 +417,6 @@ void MinSpinOSO_CG::advance_spins() } } -/* ---------------------------------------------------------------------- - compute and return max_i||mag. torque_i||_2 -------------------------------------------------------------------------- */ - -double MinSpinOSO_CG::max_torque() -{ - double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - double factor; - double hbar = force->hplanck/MY_2PI; - - if (use_line_search) factor = 1.0; - else factor = hbar; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = 0.0; - for (int j = 0; j < 3; j++) - fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - return sqrt(fmaxsqall) * factor; -} - /* ---------------------------------------------------------------------- calculate 3x3 matrix exponential using Rodrigues' formula (R. Murray, Z. Li, and S. Shankar Sastry, @@ -456,15 +438,14 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) fabs(upp_tr[1]) < 1.0e-40 && fabs(upp_tr[2]) < 1.0e-40){ - // if upp_tr is zero, return unity matrix - for(int k = 0; k < 3; k++){ - for(int m = 0; m < 3; m++){ - if (m == k) - out[3 * k + m] = 1.0; - else - out[3 * k + m] = 0.0; + // if upp_tr is zero, return unity matrix + + for(int k = 0; k < 3; k++){ + for(int m = 0; m < 3; m++){ + if (m == k) out[3 * k + m] = 1.0; + else out[3 * k + m] = 0.0; + } } - } return; } @@ -512,13 +493,14 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ - //out[i] *= 0.0; out[i] = 0.0; - for(int j = 0; j < 3; j++) - out[i] += *(m + 3 * j + i) * v[j]; + for(int j = 0; j < 3; j++) out[i] += *(m + 3 * j + i) * v[j]; } } +/* ---------------------------------------------------------------------- + advance spins +------------------------------------------------------------------------- */ void MinSpinOSO_CG::make_step(double c, double *energy_and_der) { @@ -586,7 +568,7 @@ int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) } return 1; } - else{ + else { double r,f0,f1,df0,df1; r = b - a; f0 = eprevious; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index 41253f440f..30d9adf066 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -25,44 +25,44 @@ MinimizeStyle(spin_oso_cg, MinSpinOSO_CG) namespace LAMMPS_NS { class MinSpinOSO_CG: public Min { - public: - MinSpinOSO_CG(class LAMMPS *); - virtual ~MinSpinOSO_CG(); - void init(); - void setup_style(); - int modify_param(int, char **); - void reset_vectors(); - int iterate(int); - private: - double dt; // global timestep - double dts; // spin timestep - int ireplica,nreplica; // for neb - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector - double **sp_copy; // copy of the spins - int local_iter; // for neb - int nlocal_max; // max value of nlocal (for size of lists) - double discrete_factor; // factor for spin timestep evaluation + public: + MinSpinOSO_CG(class LAMMPS *); + virtual ~MinSpinOSO_CG(); + void init(); + void setup_style(); + void reset_vectors(); + int modify_param(int, char **); + int iterate(int); - double evaluate_dt(); - void advance_spins(); - void calc_gradient(); - void calc_search_direction(); - double maximum_rotation(double *); - void vm3(const double *, const double *, double *); - void rodrigues_rotation(const double *, double *); - int calc_and_make_step(double, double, int); - int awc(double, double, double, double); - void make_step(double, double *); - double max_torque(); - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - int use_line_search; // use line search or not. + private: + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + int use_line_search; // use line search or not. + int ireplica,nreplica; // for neb + double dt; // global timestep + double dts; // spin timestep + double discrete_factor; // factor for spin timestep evaluation + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector + double **sp_copy; // copy of the spins - bigint last_negative; + void advance_spins(); + void calc_gradient(); + void calc_search_direction(); + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); + void make_step(double, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + double evaluate_dt(); + double maximum_rotation(double *); + + bigint last_negative; }; } diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index b9315d706e..2913ef4101 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -26,9 +26,9 @@ #include #include #include "min_spin_oso_lbfgs.h" -#include "universe.h" #include "atom.h" #include "citeme.h" +#include "comm.h" #include "force.h" #include "update.h" #include "output.h" @@ -107,6 +107,13 @@ void MinSpinOSO_LBFGS::init() Min::init(); + // warning if line_search combined to gneb + + if ((nreplica >= 1) && (linestyle != 4) && (comm->me == 0)) + error->warning(FLERR,"Line search incompatible gneb"); + + // set back use_line_search to 0 if more than one replica + if (linestyle != 4 && nreplica == 1){ use_line_search = 1; } @@ -188,7 +195,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) { int nlocal = atom->nlocal; bigint ntimestep; - double fmdotfm; + double fmdotfm,fmsq,fmsqall; int flag, flagall; double **sp = atom->sp; double der_e_cur_tmp = 0.0; @@ -280,8 +287,20 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) // magnetic torque tolerance criterion // sync across replicas if running multi-replica minimization + fmdotfm = fmsq = fmsqall = 0.0; if (update->ftol > 0.0) { - fmdotfm = max_torque(); + if (normstyle == 1) { // max torque norm + fmsq = max_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_MAX,universe->uworld); + } else { // Euclidean torque norm + fmsq = total_torque(); + fmsqall = fmsq; + if (update->multireplica == 0) + MPI_Allreduce(&fmsq,&fmsqall,1,MPI_INT,MPI_SUM,universe->uworld); + } + fmdotfm = fmsqall*fmsqall; if (update->multireplica == 0) { if (fmdotfm < update->ftol*update->ftol) return FTOL; } else { @@ -534,42 +553,6 @@ void MinSpinOSO_LBFGS::advance_spins() } } -/* ---------------------------------------------------------------------- - compute and return max_i||mag. torque_i||_2 -------------------------------------------------------------------------- */ - -double MinSpinOSO_LBFGS::max_torque() -{ - double fmsq,fmaxsqone,fmaxsqloc,fmaxsqall; - int nlocal = atom->nlocal; - - // finding max fm on this proc. - - fmsq = fmaxsqone = fmaxsqloc = fmaxsqall = 0.0; - for (int i = 0; i < nlocal; i++) { - fmsq = 0.0; - for (int j = 0; j < 3; j++) - fmsq += g_cur[3 * i + j] * g_cur[3 * i + j]; - fmaxsqone = MAX(fmaxsqone,fmsq); - } - - // finding max fm on this replica - - fmaxsqloc = fmaxsqone; - MPI_Allreduce(&fmaxsqone,&fmaxsqloc,1,MPI_DOUBLE,MPI_MAX,world); - - // finding max fm over all replicas, if necessary - // this communicator would be invalid for multiprocess replicas - - fmaxsqall = fmaxsqloc; - if (update->multireplica == 1) { - fmaxsqall = fmaxsqloc; - MPI_Allreduce(&fmaxsqloc,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,universe->uworld); - } - - return sqrt(fmaxsqall); -} - /* ---------------------------------------------------------------------- calculate 3x3 matrix exponential using Rodrigues' formula (R. Murray, Z. Li, and S. Shankar Sastry, diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 204f6bf058..9bd36afa8b 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -25,45 +25,45 @@ MinimizeStyle(spin_oso_lbfgs, MinSpinOSO_LBFGS) namespace LAMMPS_NS { class MinSpinOSO_LBFGS: public Min { - public: - MinSpinOSO_LBFGS(class LAMMPS *); - virtual ~MinSpinOSO_LBFGS(); - void init(); - void setup_style(); - int modify_param(int, char **); - void reset_vectors(); - int iterate(int); - private: - int ireplica,nreplica; // for neb - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector - int local_iter; // for neb - int nlocal_max; // max value of nlocal (for size of lists) + public: + MinSpinOSO_LBFGS(class LAMMPS *); + virtual ~MinSpinOSO_LBFGS(); + void init(); + void setup_style(); + int modify_param(int, char **); + void reset_vectors(); + int iterate(int); - void advance_spins(); - void calc_gradient(); - void calc_search_direction(); - double maximum_rotation(double *); - void vm3(const double *, const double *, double *); - void rodrigues_rotation(const double *, double *); - int calc_and_make_step(double, double, int); - int awc(double, double, double, double); - void make_step(double, double *); - double max_torque(); - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - int use_line_search; // use line search or not. - double maxepsrot; + private: + int local_iter; // for neb + int use_line_search; // use line search or not. + int nlocal_max; // max value of nlocal (for size of lists) + int ireplica,nreplica; // for neb + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + double maxepsrot; + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector - double *rho; // estimation of curvature - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg - double **sp_copy; // copy of the spins - int num_mem; // number of stored steps - bigint last_negative; + void advance_spins(); + void calc_gradient(); + void calc_search_direction(); + void vm3(const double *, const double *, double *); + void rodrigues_rotation(const double *, double *); + void make_step(double, double *); + int calc_and_make_step(double, double, int); + int awc(double, double, double, double); + double maximum_rotation(double *); + + double *rho; // estimation of curvature + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double **sp_copy; // copy of the spins + int num_mem; // number of stored steps + bigint last_negative; }; } diff --git a/src/min.cpp b/src/min.cpp index 2a42a444a0..e476b1abc8 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -42,10 +42,12 @@ #include "output.h" #include "thermo.h" #include "timer.h" +#include "math_const.h" #include "memory.h" #include "error.h" using namespace LAMMPS_NS; +using namespace MathConst; /* ---------------------------------------------------------------------- */ @@ -54,6 +56,7 @@ Min::Min(LAMMPS *lmp) : Pointers(lmp) dmax = 0.1; searchflag = 0; linestyle = 1; + normstyle = 0; elist_global = elist_atom = NULL; vlist_global = vlist_atom = NULL; @@ -653,6 +656,14 @@ void Min::modify_params(int narg, char **arg) if (strcmp(arg[iarg+1],"backtrack") == 0) linestyle = 0; else if (strcmp(arg[iarg+1],"quadratic") == 0) linestyle = 1; else if (strcmp(arg[iarg+1],"forcezero") == 0) linestyle = 2; + else if (strcmp(arg[iarg+1],"spin_cubic") == 0) linestyle = 3; + else if (strcmp(arg[iarg+1],"spin_none") == 0) linestyle = 4; + else error->all(FLERR,"Illegal min_modify command"); + iarg += 2; + } else if (strcmp(arg[iarg],"norm") == 0) { + if (iarg+2 > narg) error->all(FLERR,"Illegal min_modify command"); + if (strcmp(arg[iarg+1],"euclidean") == 0) normstyle = 0; + else if (strcmp(arg[iarg+1],"max") == 0) normstyle = 1; else error->all(FLERR,"Illegal min_modify command"); iarg += 2; } else { @@ -816,6 +827,69 @@ double Min::fnorm_inf() return norm_inf; } +/* ---------------------------------------------------------------------- + compute and return sum_i||mag. torque_i||_2 (in eV) +------------------------------------------------------------------------- */ + +double Min::total_torque() +{ + double fmsq,ftotsqone,ftotsqall; + int nlocal = atom->nlocal; + double hbar = force->hplanck/MY_2PI; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + fmsq = ftotsqone = ftotsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = fm[i][1] * sp[i][2] - fm[i][2] * sp[i][1]; + ty = fm[i][2] * sp[i][0] - fm[i][0] * sp[i][2]; + tz = fm[i][0] * sp[i][1] - fm[i][1] * sp[i][0]; + fmsq = tx * tx + ty * ty + tz * tz; + ftotsqone += fmsq; + } + + // summing all fmsqtot on this replica + + MPI_Allreduce(&ftotsqone,&ftotsqall,1,MPI_DOUBLE,MPI_SUM,world); + + // multiply it by hbar so that units are in eV + + return sqrt(ftotsqall) * hbar; +} + +/* ---------------------------------------------------------------------- + compute and return max_i ||mag. torque_i|| (in eV) +------------------------------------------------------------------------- */ + +double Min::max_torque() +{ + double fmsq,fmaxsqone,fmaxsqall; + int nlocal = atom->nlocal; + double hbar = force->hplanck/MY_2PI; + double tx,ty,tz; + double **sp = atom->sp; + double **fm = atom->fm; + + fmsq = fmaxsqone = fmaxsqall = 0.0; + for (int i = 0; i < nlocal; i++) { + tx = fm[i][1] * sp[i][2] - fm[i][2] * sp[i][1]; + ty = fm[i][2] * sp[i][0] - fm[i][0] * sp[i][2]; + tz = fm[i][0] * sp[i][1] - fm[i][1] * sp[i][0]; + fmsq = tx * tx + ty * ty + tz * tz; + fmaxsqone = MAX(fmaxsqone,fmsq); + } + + // finding max fm on this replica + + fmaxsqall = fmaxsqone; + MPI_Allreduce(&fmaxsqone,&fmaxsqall,1,MPI_DOUBLE,MPI_MAX,world); + + // multiply it by hbar so that units are in eV + + return sqrt(fmaxsqall) * hbar; +} + /* ---------------------------------------------------------------------- possible stop conditions ------------------------------------------------------------------------- */ diff --git a/src/min.h b/src/min.h index a63254231c..e18d0dd677 100644 --- a/src/min.h +++ b/src/min.h @@ -42,6 +42,10 @@ class Min : protected Pointers { double fnorm_sqr(); double fnorm_inf(); + // methods for spin minimizers + double max_torque(); + double total_torque(); + virtual void init_style() {} virtual void setup_style() = 0; virtual void reset_vectors() = 0; @@ -56,8 +60,11 @@ class Min : protected Pointers { int virial_style; // compute virial explicitly or implicitly int external_force_clear; // clear forces locally or externally - double dmax; // max dist to move any atom in one step - int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero + double dmax; // max dist to move any atom in one step + int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero + // 3 = spin_cubic, 4 = spin_none + + int normstyle; // 0 = Euclidean norm, 1 = inf. norm int nelist_global,nelist_atom; // # of PE,virial computes to check int nvlist_global,nvlist_atom; @@ -102,9 +109,6 @@ class Min : protected Pointers { double energy_force(int); void force_clear(); - double compute_force_norm_sqr(); - double compute_force_norm_inf(); - void ev_setup(); void ev_set(bigint); diff --git a/src/min_cg.cpp b/src/min_cg.cpp index 20e8cc30dd..9801e57f4d 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -37,7 +37,7 @@ MinCG::MinCG(LAMMPS *lmp) : MinLineSearch(lmp) {} int MinCG::iterate(int maxiter) { int i,m,n,fail,ntimestep; - double beta,gg,dot[2],dotall[2]; + double beta,gg,dot[2],dotall[2],fmax,fmaxall; double *fatom,*gatom,*hatom; // nlimit = max # of CG iterations before restarting @@ -87,10 +87,12 @@ int MinCG::iterate(int maxiter) // force tolerance criterion + fmax = fmaxall = 0.0; dot[0] = dot[1] = 0.0; for (i = 0; i < nvec; i++) { dot[0] += fvec[i]*fvec[i]; dot[1] += fvec[i]*g[i]; + fmax = MAX(fmax,fvec[i]*fvec[i]); } if (nextra_atom) for (m = 0; m < nextra_atom; m++) { @@ -100,16 +102,22 @@ int MinCG::iterate(int maxiter) for (i = 0; i < n; i++) { dot[0] += fatom[i]*fatom[i]; dot[1] += fatom[i]*gatom[i]; + fmax = MAX(fmax,fatom[i]*fatom[i]); } } MPI_Allreduce(dot,dotall,2,MPI_DOUBLE,MPI_SUM,world); + MPI_Allreduce(&fmax,&fmaxall,2,MPI_DOUBLE,MPI_MAX,world); if (nextra_global) for (i = 0; i < nextra_global; i++) { dotall[0] += fextra[i]*fextra[i]; dotall[1] += fextra[i]*gextra[i]; } - if (dotall[0] < update->ftol*update->ftol) return FTOL; + if (normstyle == 1) { // max force norm + if (fmax < update->ftol*update->ftol) return FTOL; + } else { // Euclidean force norm + if (dotall[0] < update->ftol*update->ftol) return FTOL; + } // update new search direction h from new f = -Grad(x) and old g // this is Polak-Ribieri formulation diff --git a/src/min_fire.cpp b/src/min_fire.cpp index a50071d562..a0a3bce8ba 100644 --- a/src/min_fire.cpp +++ b/src/min_fire.cpp @@ -80,7 +80,7 @@ void MinFire::reset_vectors() int MinFire::iterate(int maxiter) { bigint ntimestep; - double vmax,vdotf,vdotfall,vdotv,vdotvall,fdotf,fdotfall; + double vmax,vdotf,vdotfall,vdotv,vdotvall,fdotf,fdotfloc,fdotfall; double scale1,scale2; double dtvone,dtv,dtf,dtfm; int flag,flagall; @@ -250,7 +250,15 @@ int MinFire::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fdotf = fnorm_sqr(); + if (normstyle == 1) { // max force norm + fdotf = fnorm_inf(); + fdotfloc = fdotf; + MPI_Allreduce(&fdotfloc,&fdotf,1,MPI_INT,MPI_MAX,universe->uworld); + } else { // Euclidean force norm + fdotf = fnorm_sqr(); + fdotfloc = fdotf; + MPI_Allreduce(&fdotfloc,&fdotf,1,MPI_INT,MPI_SUM,universe->uworld); + } if (update->multireplica == 0) { if (fdotf < update->ftol*update->ftol) return FTOL; } else { diff --git a/src/min_hftn.cpp b/src/min_hftn.cpp index 0c834fbeb4..9f8695f151 100644 --- a/src/min_hftn.cpp +++ b/src/min_hftn.cpp @@ -20,6 +20,7 @@ #include #include #include "atom.h" +#include "error.h" #include "fix_minimize.h" #include "min_hftn.h" #include "modify.h" @@ -111,6 +112,9 @@ void MinHFTN::init() { Min::init(); + if (normstyle == 1) + error->all(FLERR,"Incorrect min_modify option"); + for (int i = 1; i < NUM_HFTN_ATOM_BASED_VECTORS; i++) { if (_daExtraGlobal[i] != NULL) delete [] _daExtraGlobal[i]; diff --git a/src/min_quickmin.cpp b/src/min_quickmin.cpp index 8b48816355..d6507cfcde 100644 --- a/src/min_quickmin.cpp +++ b/src/min_quickmin.cpp @@ -76,7 +76,7 @@ void MinQuickMin::reset_vectors() int MinQuickMin::iterate(int maxiter) { bigint ntimestep; - double vmax,vdotf,vdotfall,fdotf,fdotfall,scale; + double vmax,vdotf,vdotfall,fdotf,fdotfloc,fdotfall,scale; double dtvone,dtv,dtf,dtfm; int flag,flagall; @@ -216,7 +216,15 @@ int MinQuickMin::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - fdotf = fnorm_sqr(); + if (normstyle == 1) { // max force norm + fdotf = fnorm_inf(); + fdotfloc = fdotf; + MPI_Allreduce(&fdotfloc,&fdotf,1,MPI_INT,MPI_MAX,universe->uworld); + } else { // Euclidean force norm + fdotf = fnorm_sqr(); + fdotfloc = fdotf; + MPI_Allreduce(&fdotfloc,&fdotf,1,MPI_INT,MPI_SUM,universe->uworld); + } if (update->multireplica == 0) { if (fdotf < update->ftol*update->ftol) return FTOL; } else { diff --git a/src/min_sd.cpp b/src/min_sd.cpp index 5d44437ca0..60386df82c 100644 --- a/src/min_sd.cpp +++ b/src/min_sd.cpp @@ -79,7 +79,8 @@ int MinSD::iterate(int maxiter) // force tolerance criterion - fdotf = fnorm_sqr(); + if (normstyle == 1) fdotf = fnorm_inf(); // max force norm + else fdotf = fnorm_sqr(); // Euclidean force norm if (fdotf < update->ftol*update->ftol) return FTOL; // set new search direction h to f = -Grad(x) From 1364329432bef1809811b4e188e02520091ed825 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 26 Jul 2019 17:54:04 -0600 Subject: [PATCH 081/557] Commit JT 072619 - draft doc of norm option (doc/src/min_modify.txt) --- doc/src/min_modify.txt | 10 ++++++++++ 1 file changed, 10 insertions(+) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index 9c4d7c8fcb..ecd4795a8f 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -18,6 +18,8 @@ keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} max = maximum distance for line search to move (distance units) {line} value = {backtrack} or {quadratic} or {forcezero} or {spin_cubic} or {spin_none} backtrack,quadratic,forcezero,spin_cubic,spin_none = style of linesearch to use + {norm} value = {euclidean} or {max} + euclidean,max = style of norm to use {alpha_damp} value = damping damping = fictitious Gilbert damping for spin minimization (adim) {discrete_factor} value = factor @@ -69,6 +71,14 @@ difference of two large values (energy before and energy after) and that difference may be smaller than machine epsilon even if atoms could move in the gradient direction to reduce forces further. +The choice of a norm can be modified for the min styles {fire}, +{quickmin}, {sd}, {spin}, {spin_oso_cg} and {spin_oso_lbfgs} +using the {norm} keyword. +The default {euclidean} norm computes the 2-norm (length) of the +global force vector. The {max} norm computes the maximum value +of the 2-norms of all forces in the system. + + Keywords {alpha_damp} and {discrete_factor} only make sense when a "min_spin"_min_spin.html command is declared. Keyword {alpha_damp} defines an analog of a magnetic Gilbert From 000d5b7cc278b0f8ecdc22e2f3370b30356045c8 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 20:02:31 -0400 Subject: [PATCH 082/557] simplify code a little and remove excess whitespace --- src/MISC/fix_deposit.cpp | 7 ++----- 1 file changed, 2 insertions(+), 5 deletions(-) diff --git a/src/MISC/fix_deposit.cpp b/src/MISC/fix_deposit.cpp index 66493f810f..06ce7a464d 100644 --- a/src/MISC/fix_deposit.cpp +++ b/src/MISC/fix_deposit.cpp @@ -184,14 +184,11 @@ FixDeposit::FixDeposit(LAMMPS *lmp, int narg, char **arg) : if (idnext) find_maxid(); // random number generator, same for all procs - // warm-up the generator 30x to avoid correlations in first-particle + // warm up the generator 30x to avoid correlations in first-particle // positions if runs are repeated with consecutive seeds random = new RanPark(lmp,seed); - double tmp_rand; - for (int ii=0; ii < 30; ii++) { - tmp_rand = random->uniform(); - } + for (int ii=0; ii < 30; ii++) random->uniform(); // set up reneighboring From 0f9112d9866255dc56ef45159e725e3cfcb7b99b Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 29 Jul 2019 20:03:16 -0400 Subject: [PATCH 083/557] transfer pRNG init changes from fix deposit to fix pour --- src/GRANULAR/fix_pour.cpp | 3 +++ 1 file changed, 3 insertions(+) diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 3ffca8db9d..6372575333 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -166,8 +166,11 @@ FixPour::FixPour(LAMMPS *lmp, int narg, char **arg) : if (idnext) find_maxid(); // random number generator, same for all procs + // warm up the generator 30x to avoid correlations in first-particle + // positions if runs are repeated with consecutive seeds random = new RanPark(lmp,seed); + for (int ii=0; ii < 30; ii++) random->uniform(); // allgather arrays From 9609c75073130b19856c3bc0e64068e72254e507 Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 30 Jul 2019 11:16:40 +0000 Subject: [PATCH 084/557] Use descent condition, and no line search as a default option for all oso --- examples/SPIN/spinmin/in.spinmin_cg.bfo | 2 +- examples/SPIN/spinmin/in.spinmin_lbfgs.bfo | 4 ++-- src/SPIN/min_spin_oso_cg.cpp | 14 ++++---------- src/SPIN/min_spin_oso_cg.h | 2 +- src/SPIN/min_spin_oso_lbfgs.cpp | 21 ++++++--------------- src/SPIN/min_spin_oso_lbfgs.h | 2 +- 6 files changed, 15 insertions(+), 30 deletions(-) diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spinmin_cg.bfo index 776079edb8..8c288763c4 100644 --- a/examples/SPIN/spinmin/in.spinmin_cg.bfo +++ b/examples/SPIN/spinmin/in.spinmin_cg.bfo @@ -51,4 +51,4 @@ dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3 min_style spin_oso_cg # min_modify line spin_none discrete_factor 10.0 -minimize 1.0e-10 1.0e-7 1000 1000 +minimize 1.0e-10 1.0e-10 10000 10000 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo index ca600f1c2b..6a9104cc9c 100644 --- a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo +++ b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo @@ -50,5 +50,5 @@ compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] min_style spin_oso_lbfgs -min_modify line spin_cubic discrete_factor 10.0 -minimize 1.0e-15 1.0e-7 10000 1000 +# min_modify line spin_cubic discrete_factor 10.0 +minimize 1.0e-15 1.0e-10 10000 1000 diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_oso_cg.cpp index 16a95c5c02..f1f2f72436 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_oso_cg.cpp @@ -561,7 +561,7 @@ int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) der_e_cur = e_and_d[1]; index++; - if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 10){ + if (adescent(eprevious,e_and_d[0]) || index == 5){ MPI_Bcast(&b,1,MPI_DOUBLE,0,world); for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = b * p_s[i]; @@ -598,20 +598,14 @@ int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) } /* ---------------------------------------------------------------------- - Approximate Wolfe conditions: - William W. Hager and Hongchao Zhang - SIAM J. optim., 16(1), 170-192. (23 pages) + Approximate descent ------------------------------------------------------------------------- */ -int MinSpinOSO_CG::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ +int MinSpinOSO_CG::adescent(double phi_0, double phi_j){ double eps = 1.0e-6; - double delta = 0.1; - double sigma = 0.9; - if ((phi_j<=phi_0+eps*fabs(phi_0)) && - ((2.0*delta-1.0) * der_phi_0>=der_phi_j) && - (der_phi_j>=sigma*der_phi_0)) + if (phi_j<=phi_0+eps*fabs(phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_oso_cg.h index 30d9adf066..d6dc7c03d0 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_oso_cg.h @@ -58,7 +58,7 @@ class MinSpinOSO_CG: public Min { void rodrigues_rotation(const double *, double *); void make_step(double, double *); int calc_and_make_step(double, double, int); - int awc(double, double, double, double); + int adescent(double, double); double evaluate_dt(); double maximum_rotation(double *); diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_oso_lbfgs.cpp index f850879d1a..8623a8bb29 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_oso_lbfgs.cpp @@ -73,10 +73,7 @@ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : nreplica = universe->nworlds; ireplica = universe->iworld; - if (nreplica > 1) - use_line_search = 0; // no line search for NEB - else - use_line_search = 1; + use_line_search = 0; // no line search as default option for LBFGS maxepsrot = MY_2PI / (100.0); @@ -114,7 +111,7 @@ void MinSpinOSO_LBFGS::init() // set back use_line_search to 0 if more than one replica - if (linestyle != 4 && nreplica == 1){ + if (linestyle == 3 && nreplica == 1){ use_line_search = 1; } else{ @@ -694,7 +691,7 @@ int MinSpinOSO_LBFGS::calc_and_make_step(double a, double b, int index) der_e_cur = e_and_d[1]; index++; - if (awc(der_e_pr,eprevious,e_and_d[1],e_and_d[0]) || index == 5){ + if (adescent(eprevious,e_and_d[0]) || index == 5){ MPI_Bcast(&b,1,MPI_DOUBLE,0,world); for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = b * p_s[i]; @@ -731,20 +728,14 @@ int MinSpinOSO_LBFGS::calc_and_make_step(double a, double b, int index) } /* ---------------------------------------------------------------------- - Approximate Wolfe conditions: - William W. Hager and Hongchao Zhang - SIAM J. optim., 16(1), 170-192. (23 pages) + Approximate descent ------------------------------------------------------------------------- */ -int MinSpinOSO_LBFGS::awc(double der_phi_0, double phi_0, double der_phi_j, double phi_j){ +int MinSpinOSO_LBFGS::adescent(double phi_0, double phi_j){ double eps = 1.0e-6; - double delta = 0.1; - double sigma = 0.9; - if ((phi_j<=phi_0+eps*fabs(phi_0)) && - ((2.0*delta-1.0) * der_phi_0>=der_phi_j) && - (der_phi_j>=sigma*der_phi_0)) + if (phi_j<=phi_0+eps*fabs(phi_0)) return 1; else return 0; diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_oso_lbfgs.h index 9bd36afa8b..68fa10921e 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_oso_lbfgs.h @@ -55,7 +55,7 @@ class MinSpinOSO_LBFGS: public Min { void rodrigues_rotation(const double *, double *); void make_step(double, double *); int calc_and_make_step(double, double, int); - int awc(double, double, double, double); + int adescent(double, double); double maximum_rotation(double *); double *rho; // estimation of curvature From aa3c44ad4af471e3c4cc65734f3abe43179d3b27 Mon Sep 17 00:00:00 2001 From: alxvov Date: Tue, 30 Jul 2019 12:02:10 +0000 Subject: [PATCH 085/557] modify documentation a bit --- doc/src/min_modify.txt | 6 +++--- doc/src/min_spin.txt | 11 +++++------ 2 files changed, 8 insertions(+), 9 deletions(-) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index ecd4795a8f..35a02c47c3 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -97,9 +97,9 @@ two minimization styles is declared. The {spin_cubic} performs the line search based on a cubic interpolation of the energy along the search direction. The {spin_none} keyword deactivates the line search procedure. -The {spin_none} is a default value for {line} keyword apart from the case when -single-replica calculations are performed with {spin_oso_lbfgs} that -uses {spin_cubic} line search. +The {spin_none} is a default value for {line} keyword for both {spin_oso_lbfgs} +and {spin_oso_cg}. Convergence of {spin_oso_lbfgs} can be more robust if +{spin_cubic} line search is used. [Restrictions:] The line search procedure of styles {spin_oso_cg} and {spin_oso_lbfgs} cannot be used for magnetic diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 77dc008b3e..20c4cde1d7 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -18,7 +18,7 @@ min_style spin_oso_lbfgs :pre [Examples:] min_style spin_oso_lbfgs -min_modify line spin_none discrete_factor 10.0 :pre +min_modify line spin_cubic discrete_factor 10.0 :pre [Description:] @@ -62,16 +62,15 @@ and uses the adaptive time-step technique in the same way as style {spin}. Style {spin_oso_lbfgs} defines an orthogonal spin optimization (OSO) combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno (L-BFGS) algorithm. -By default, style {spin_oso_lbfgs} uses a line search procedure -based on cubic interpolation for -a single-replica calculation, and it does not use line search procedure -for a multireplica calculation (such as in case of GNEB calculation). +By default, style {spin_oso_lbfgs} does not employ line search procedure. If the line search procedure is not used then the discrete factor defines the maximum root mean squared rotation angle of spins by equation {pi/(5*Kappa)}. The default value for Kappa is 10. +The {spin_cubic} line search can improve +the convergence of the {spin_oso_lbfgs} algorithm. The "min_modify"_min_modify.html command can be used to -deactivate the line search procedure, and to modify the +activate the line search procedure, and to modify the discretization factor {discrete_factor}. For more information about styles {spin_oso_cg} and {spin_oso_lbfgs}, From 74fa4f741571be0bb060462691d76651d10394e8 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 30 Jul 2019 08:58:12 -0600 Subject: [PATCH 086/557] Commit JT 073019 - modified doc doc/src/min_modify.txt - tested lattice minimizers with norm styles --- doc/src/min_modify.txt | 19 +++++++++++-------- doc/src/min_spin.txt | 10 +++++----- doc/src/min_style.txt | 3 +-- 3 files changed, 17 insertions(+), 15 deletions(-) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index 35a02c47c3..2056655d40 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -13,7 +13,7 @@ min_modify command :h3 min_modify keyword values ... :pre one or more keyword/value pairs may be listed :ulb,l -keyword = {dmax} or {line} or {alpha_damp} or {discrete_factor} +keyword = {dmax} or {line} or {norm} or {alpha_damp} or {discrete_factor} {dmax} value = max max = maximum distance for line search to move (distance units) {line} value = {backtrack} or {quadratic} or {forcezero} or {spin_cubic} or {spin_none} @@ -71,13 +71,12 @@ difference of two large values (energy before and energy after) and that difference may be smaller than machine epsilon even if atoms could move in the gradient direction to reduce forces further. -The choice of a norm can be modified for the min styles {fire}, -{quickmin}, {sd}, {spin}, {spin_oso_cg} and {spin_oso_lbfgs} -using the {norm} keyword. +The choice of a norm can be modified for the min styles {cg}, {sd}, +{quickmin}, {fire}, {spin}, {spin_oso_cg} and {spin_oso_lbfgs} using +the {norm} keyword. The default {euclidean} norm computes the 2-norm (length) of the global force vector. The {max} norm computes the maximum value -of the 2-norms of all forces in the system. - +of the 2-norms across all forces in the system. Keywords {alpha_damp} and {discrete_factor} only make sense when a "min_spin"_min_spin.html command is declared. @@ -88,7 +87,6 @@ Keyword {discrete_factor} defines a discretization factor for the adaptive timestep used in the {spin} minimization. See "min_spin"_min_spin.html for more information about those quantities. -Default values are {alpha_damp} = 1.0 and {discrete_factor} = 10.0. The choice of a line search algorithm for the {spin_oso_cg} and {spin_oso_lbfgs} styles can be specified via the {line} keyword. @@ -112,4 +110,9 @@ explanation. [Default:] -The option defaults are dmax = 0.1 and line = quadratic. +The option defaults are dmax = 0.1, line = quadratic and norm = +euclidean. + +For the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles, the +option defaults are alpha_damp = 1.0, discrete_factor = 10.0, +line = spin_none, and norm = euclidean. diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 20c4cde1d7..575db2dc74 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -56,7 +56,7 @@ Style {spin_oso_cg} defines an orthogonal spin optimization The "min_modify"_min_modify.html command can be used to couple the {spin_oso_cg} to a line search procedure, and to modify the discretization factor {discrete_factor}. -By defualt, the style {spin_oso_cg} does not employ line search procedure and +By default, style {spin_oso_cg} does not employ the line search procedure and uses the adaptive time-step technique in the same way as style {spin}. Style {spin_oso_lbfgs} defines an orthogonal spin optimization @@ -66,8 +66,8 @@ By default, style {spin_oso_lbfgs} does not employ line search procedure. If the line search procedure is not used then the discrete factor defines the maximum root mean squared rotation angle of spins by equation {pi/(5*Kappa)}. The default value for Kappa is 10. -The {spin_cubic} line search can improve -the convergence of the {spin_oso_lbfgs} algorithm. +The {spin_cubic} line search can improve the convergence of the +{spin_oso_lbfgs} algorithm. The "min_modify"_min_modify.html command can be used to activate the line search procedure, and to modify the @@ -95,8 +95,8 @@ freedom for a frozen lattice configuration. [Default:] -The option defaults are {alpha_damp} = 1.0 and {discrete_factor} = -10.0. +The option defaults are {alpha_damp} = 1.0, {discrete_factor} = +10.0, {line} = spin_none and {norm} = euclidean. :line diff --git a/doc/src/min_style.txt b/doc/src/min_style.txt index 081ec17889..7c40fd4947 100644 --- a/doc/src/min_style.txt +++ b/doc/src/min_style.txt @@ -11,8 +11,7 @@ min_style command :h3 min_style style :pre -style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} -or {spin_oso_cg} or {spin_oso_lbfgs} :ul +style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} or {spin_oso_cg} or {spin_oso_lbfgs} :ul [Examples:] From f4e3186abf95e0b0d6efd165c84a693ca295f448 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 30 Jul 2019 13:10:27 -0600 Subject: [PATCH 087/557] Commit JT 073019 - modified the false_positive file to correct errors - improved the doc page of fix nve/spin --- doc/src/fix_nve_spin.txt | 15 +++++++++++---- doc/src/min_modify.txt | 3 +-- doc/utils/sphinx-config/false_positives.txt | 5 +++++ 3 files changed, 17 insertions(+), 6 deletions(-) diff --git a/doc/src/fix_nve_spin.txt b/doc/src/fix_nve_spin.txt index 7b382bb6ad..30df484e54 100644 --- a/doc/src/fix_nve_spin.txt +++ b/doc/src/fix_nve_spin.txt @@ -27,10 +27,16 @@ fix 1 all nve/spin lattice no :pre Perform a symplectic integration for the spin or spin-lattice system. -The {lattice} keyword defines if the spins are integrated on a lattice -of fixed atoms (lattice = no), or if atoms are moving (lattice = yes). +The {lattice} keyword defines whether the spins are integrated on a +fixed or moving lattice. -By default (lattice = yes), a spin-lattice integration is performed. +If {lattice}=yes, the equations of motion of the atoms are integrated, +and a combined spin and lattice calculation is performed. +This is the default option. + +If {lattice}=no, the equations of motion of the atoms are not +integrated. The lattice degrees of freedom are frozen, and a +spin dynamics only calculation is performed. The {nve/spin} fix applies a Suzuki-Trotter decomposition to the equations of motion of the spin lattice system, following the scheme: @@ -63,7 +69,8 @@ instead of "array" is also valid. "atom_style spin"_atom_style.html, "fix nve"_fix_nve.html -[Default:] none +[Default:] By default (lattice = yes), a spin-lattice integration is +performed. :line diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index 2056655d40..857c3551aa 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -110,8 +110,7 @@ explanation. [Default:] -The option defaults are dmax = 0.1, line = quadratic and norm = -euclidean. +The option defaults are dmax = 0.1, line = quadratic and norm = euclidean. For the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles, the option defaults are alpha_damp = 1.0, discrete_factor = 10.0, diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 1dea229393..417738998e 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -273,6 +273,7 @@ Broadwell Broglie brownian brownw +Broyden Bryantsev Btarget btype @@ -981,6 +982,7 @@ gmask Gmask gneb GNEB +Goldfarb googlemail Gordan GPa @@ -1395,6 +1397,7 @@ Laupretre lavenderblush lawngreen lB +lbfgs lbl LBtype lcbop @@ -2030,6 +2033,7 @@ Orsi ortho orthonormal orthorhombic +oso ot Otype Ouldridge @@ -2493,6 +2497,7 @@ setvel sfftw Sg Shan +Shanno shapex shapey shapez From 55a7200246e5f3253d3f964e086a2cee8ba24048 Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Wed, 7 Aug 2019 12:13:49 -0700 Subject: [PATCH 088/557] updates to src/fix_langevin.cpp --- src/fix_langevin.cpp | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 723f4be2e4..ea0929a236 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -18,10 +18,11 @@ Niels Gronbech-Jensen (UC Davis) GJF-2GJ Formulation ------------------------------------------------------------------------- */ -#include "fix_langevin.h" #include #include #include +#include +#include "fix_langevin.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" @@ -29,6 +30,8 @@ #include "update.h" #include "modify.h" #include "compute.h" +#include "domain.h" +#include "region.h" #include "respa.h" #include "comm.h" #include "input.h" From ef3f382f61f436540fe6fc980f6fd40b876c793a Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Wed, 7 Aug 2019 17:27:35 -0700 Subject: [PATCH 089/557] fixed tbias --- examples/python/gjf_python/README.md | 18 - examples/python/gjf_python/argon.lmp | 886 --------------------- examples/python/gjf_python/ff-argon.lmp | 20 - examples/python/gjf_python/gjf.py | 180 ----- examples/python/gjf_python/lammps_tools.py | 78 -- src/fix_langevin.cpp | 142 +++- src/fix_langevin.h | 1 + 7 files changed, 117 insertions(+), 1208 deletions(-) delete mode 100644 examples/python/gjf_python/README.md delete mode 100644 examples/python/gjf_python/argon.lmp delete mode 100644 examples/python/gjf_python/ff-argon.lmp delete mode 100644 examples/python/gjf_python/gjf.py delete mode 100644 examples/python/gjf_python/lammps_tools.py diff --git a/examples/python/gjf_python/README.md b/examples/python/gjf_python/README.md deleted file mode 100644 index 707289f02d..0000000000 --- a/examples/python/gjf_python/README.md +++ /dev/null @@ -1,18 +0,0 @@ -# LAMMPS GJF-2GJ THERMOSTAT EXAMPLE W/ PYTHON - -## GJF-2GJ THERMOSTAT - -This directory contains a python script to run NVT simulations using the GJF-2GJ thermostat. -The script will vary the timestep and write thermodynamic output to screen. -This script has True/False options to change how you would like to dump/write your output. - -Example: -``` -NP=4 #number of processors -mpirun -np $NP python gjf.py -``` - -## Required LAMMPS packages: MOLECULE package -## LAMMPS COMPILE MODE: SHLIB -## LAMMPS OPTIONAL INSTALL: make install-python -## Required Python packages: mpi4py diff --git a/examples/python/gjf_python/argon.lmp b/examples/python/gjf_python/argon.lmp deleted file mode 100644 index 00214b4c54..0000000000 --- a/examples/python/gjf_python/argon.lmp +++ /dev/null @@ -1,886 +0,0 @@ -LAMMPS description - - 864 atoms - 0 bonds - 0 angles - 0 dihedrals - 0 impropers - - 1 atom types - 0 bond types - 0 angle types - 0 dihedral types - 0 improper types - - - 0.0000000 32.146000 xlo xhi - 0.0000000 32.146000 ylo yhi - 0.0000000 32.146000 zlo zhi - - Atoms - - 1 1 1 0.0000000 0.0000000 2.6790000 2.6790000 - 2 2 1 0.0000000 0.0000000 2.6790000 8.0360000 - 3 3 1 0.0000000 0.0000000 2.6790000 13.3940000 - 4 4 1 0.0000000 0.0000000 2.6790000 18.7520000 - 5 5 1 0.0000000 0.0000000 2.6790000 24.1090000 - 6 6 1 0.0000000 0.0000000 2.6790000 29.4670000 - 7 7 1 0.0000000 0.0000000 8.0360000 2.6790000 - 8 8 1 0.0000000 0.0000000 8.0360000 8.0360000 - 9 9 1 0.0000000 0.0000000 8.0360000 13.3940000 - 10 10 1 0.0000000 0.0000000 8.0360000 18.7520000 - 11 11 1 0.0000000 0.0000000 8.0360000 24.1090000 - 12 12 1 0.0000000 0.0000000 8.0360000 29.4670000 - 13 13 1 0.0000000 0.0000000 13.3940000 2.6790000 - 14 14 1 0.0000000 0.0000000 13.3940000 8.0360000 - 15 15 1 0.0000000 0.0000000 13.3940000 13.3940000 - 16 16 1 0.0000000 0.0000000 13.3940000 18.7520000 - 17 17 1 0.0000000 0.0000000 13.3940000 24.1090000 - 18 18 1 0.0000000 0.0000000 13.3940000 29.4670000 - 19 19 1 0.0000000 0.0000000 18.7520000 2.6790000 - 20 20 1 0.0000000 0.0000000 18.7520000 8.0360000 - 21 21 1 0.0000000 0.0000000 18.7520000 13.3940000 - 22 22 1 0.0000000 0.0000000 18.7520000 18.7520000 - 23 23 1 0.0000000 0.0000000 18.7520000 24.1090000 - 24 24 1 0.0000000 0.0000000 18.7520000 29.4670000 - 25 25 1 0.0000000 0.0000000 24.1090000 2.6790000 - 26 26 1 0.0000000 0.0000000 24.1090000 8.0360000 - 27 27 1 0.0000000 0.0000000 24.1090000 13.3940000 - 28 28 1 0.0000000 0.0000000 24.1090000 18.7520000 - 29 29 1 0.0000000 0.0000000 24.1090000 24.1090000 - 30 30 1 0.0000000 0.0000000 24.1090000 29.4670000 - 31 31 1 0.0000000 0.0000000 29.4670000 2.6790000 - 32 32 1 0.0000000 0.0000000 29.4670000 8.0360000 - 33 33 1 0.0000000 0.0000000 29.4670000 13.3940000 - 34 34 1 0.0000000 0.0000000 29.4670000 18.7520000 - 35 35 1 0.0000000 0.0000000 29.4670000 24.1090000 - 36 36 1 0.0000000 0.0000000 29.4670000 29.4670000 - 37 37 1 0.0000000 5.3580000 2.6790000 2.6790000 - 38 38 1 0.0000000 5.3580000 2.6790000 8.0360000 - 39 39 1 0.0000000 5.3580000 2.6790000 13.3940000 - 40 40 1 0.0000000 5.3580000 2.6790000 18.7520000 - 41 41 1 0.0000000 5.3580000 2.6790000 24.1090000 - 42 42 1 0.0000000 5.3580000 2.6790000 29.4670000 - 43 43 1 0.0000000 5.3580000 8.0360000 2.6790000 - 44 44 1 0.0000000 5.3580000 8.0360000 8.0360000 - 45 45 1 0.0000000 5.3580000 8.0360000 13.3940000 - 46 46 1 0.0000000 5.3580000 8.0360000 18.7520000 - 47 47 1 0.0000000 5.3580000 8.0360000 24.1090000 - 48 48 1 0.0000000 5.3580000 8.0360000 29.4670000 - 49 49 1 0.0000000 5.3580000 13.3940000 2.6790000 - 50 50 1 0.0000000 5.3580000 13.3940000 8.0360000 - 51 51 1 0.0000000 5.3580000 13.3940000 13.3940000 - 52 52 1 0.0000000 5.3580000 13.3940000 18.7520000 - 53 53 1 0.0000000 5.3580000 13.3940000 24.1090000 - 54 54 1 0.0000000 5.3580000 13.3940000 29.4670000 - 55 55 1 0.0000000 5.3580000 18.7520000 2.6790000 - 56 56 1 0.0000000 5.3580000 18.7520000 8.0360000 - 57 57 1 0.0000000 5.3580000 18.7520000 13.3940000 - 58 58 1 0.0000000 5.3580000 18.7520000 18.7520000 - 59 59 1 0.0000000 5.3580000 18.7520000 24.1090000 - 60 60 1 0.0000000 5.3580000 18.7520000 29.4670000 - 61 61 1 0.0000000 5.3580000 24.1090000 2.6790000 - 62 62 1 0.0000000 5.3580000 24.1090000 8.0360000 - 63 63 1 0.0000000 5.3580000 24.1090000 13.3940000 - 64 64 1 0.0000000 5.3580000 24.1090000 18.7520000 - 65 65 1 0.0000000 5.3580000 24.1090000 24.1090000 - 66 66 1 0.0000000 5.3580000 24.1090000 29.4670000 - 67 67 1 0.0000000 5.3580000 29.4670000 2.6790000 - 68 68 1 0.0000000 5.3580000 29.4670000 8.0360000 - 69 69 1 0.0000000 5.3580000 29.4670000 13.3940000 - 70 70 1 0.0000000 5.3580000 29.4670000 18.7520000 - 71 71 1 0.0000000 5.3580000 29.4670000 24.1090000 - 72 72 1 0.0000000 5.3580000 29.4670000 29.4670000 - 73 73 1 0.0000000 10.7150000 2.6790000 2.6790000 - 74 74 1 0.0000000 10.7150000 2.6790000 8.0360000 - 75 75 1 0.0000000 10.7150000 2.6790000 13.3940000 - 76 76 1 0.0000000 10.7150000 2.6790000 18.7520000 - 77 77 1 0.0000000 10.7150000 2.6790000 24.1090000 - 78 78 1 0.0000000 10.7150000 2.6790000 29.4670000 - 79 79 1 0.0000000 10.7150000 8.0360000 2.6790000 - 80 80 1 0.0000000 10.7150000 8.0360000 8.0360000 - 81 81 1 0.0000000 10.7150000 8.0360000 13.3940000 - 82 82 1 0.0000000 10.7150000 8.0360000 18.7520000 - 83 83 1 0.0000000 10.7150000 8.0360000 24.1090000 - 84 84 1 0.0000000 10.7150000 8.0360000 29.4670000 - 85 85 1 0.0000000 10.7150000 13.3940000 2.6790000 - 86 86 1 0.0000000 10.7150000 13.3940000 8.0360000 - 87 87 1 0.0000000 10.7150000 13.3940000 13.3940000 - 88 88 1 0.0000000 10.7150000 13.3940000 18.7520000 - 89 89 1 0.0000000 10.7150000 13.3940000 24.1090000 - 90 90 1 0.0000000 10.7150000 13.3940000 29.4670000 - 91 91 1 0.0000000 10.7150000 18.7520000 2.6790000 - 92 92 1 0.0000000 10.7150000 18.7520000 8.0360000 - 93 93 1 0.0000000 10.7150000 18.7520000 13.3940000 - 94 94 1 0.0000000 10.7150000 18.7520000 18.7520000 - 95 95 1 0.0000000 10.7150000 18.7520000 24.1090000 - 96 96 1 0.0000000 10.7150000 18.7520000 29.4670000 - 97 97 1 0.0000000 10.7150000 24.1090000 2.6790000 - 98 98 1 0.0000000 10.7150000 24.1090000 8.0360000 - 99 99 1 0.0000000 10.7150000 24.1090000 13.3940000 - 100 100 1 0.0000000 10.7150000 24.1090000 18.7520000 - 101 101 1 0.0000000 10.7150000 24.1090000 24.1090000 - 102 102 1 0.0000000 10.7150000 24.1090000 29.4670000 - 103 103 1 0.0000000 10.7150000 29.4670000 2.6790000 - 104 104 1 0.0000000 10.7150000 29.4670000 8.0360000 - 105 105 1 0.0000000 10.7150000 29.4670000 13.3940000 - 106 106 1 0.0000000 10.7150000 29.4670000 18.7520000 - 107 107 1 0.0000000 10.7150000 29.4670000 24.1090000 - 108 108 1 0.0000000 10.7150000 29.4670000 29.4670000 - 109 109 1 0.0000000 16.0730000 2.6790000 2.6790000 - 110 110 1 0.0000000 16.0730000 2.6790000 8.0360000 - 111 111 1 0.0000000 16.0730000 2.6790000 13.3940000 - 112 112 1 0.0000000 16.0730000 2.6790000 18.7520000 - 113 113 1 0.0000000 16.0730000 2.6790000 24.1090000 - 114 114 1 0.0000000 16.0730000 2.6790000 29.4670000 - 115 115 1 0.0000000 16.0730000 8.0360000 2.6790000 - 116 116 1 0.0000000 16.0730000 8.0360000 8.0360000 - 117 117 1 0.0000000 16.0730000 8.0360000 13.3940000 - 118 118 1 0.0000000 16.0730000 8.0360000 18.7520000 - 119 119 1 0.0000000 16.0730000 8.0360000 24.1090000 - 120 120 1 0.0000000 16.0730000 8.0360000 29.4670000 - 121 121 1 0.0000000 16.0730000 13.3940000 2.6790000 - 122 122 1 0.0000000 16.0730000 13.3940000 8.0360000 - 123 123 1 0.0000000 16.0730000 13.3940000 13.3940000 - 124 124 1 0.0000000 16.0730000 13.3940000 18.7520000 - 125 125 1 0.0000000 16.0730000 13.3940000 24.1090000 - 126 126 1 0.0000000 16.0730000 13.3940000 29.4670000 - 127 127 1 0.0000000 16.0730000 18.7520000 2.6790000 - 128 128 1 0.0000000 16.0730000 18.7520000 8.0360000 - 129 129 1 0.0000000 16.0730000 18.7520000 13.3940000 - 130 130 1 0.0000000 16.0730000 18.7520000 18.7520000 - 131 131 1 0.0000000 16.0730000 18.7520000 24.1090000 - 132 132 1 0.0000000 16.0730000 18.7520000 29.4670000 - 133 133 1 0.0000000 16.0730000 24.1090000 2.6790000 - 134 134 1 0.0000000 16.0730000 24.1090000 8.0360000 - 135 135 1 0.0000000 16.0730000 24.1090000 13.3940000 - 136 136 1 0.0000000 16.0730000 24.1090000 18.7520000 - 137 137 1 0.0000000 16.0730000 24.1090000 24.1090000 - 138 138 1 0.0000000 16.0730000 24.1090000 29.4670000 - 139 139 1 0.0000000 16.0730000 29.4670000 2.6790000 - 140 140 1 0.0000000 16.0730000 29.4670000 8.0360000 - 141 141 1 0.0000000 16.0730000 29.4670000 13.3940000 - 142 142 1 0.0000000 16.0730000 29.4670000 18.7520000 - 143 143 1 0.0000000 16.0730000 29.4670000 24.1090000 - 144 144 1 0.0000000 16.0730000 29.4670000 29.4670000 - 145 145 1 0.0000000 21.4310000 2.6790000 2.6790000 - 146 146 1 0.0000000 21.4310000 2.6790000 8.0360000 - 147 147 1 0.0000000 21.4310000 2.6790000 13.3940000 - 148 148 1 0.0000000 21.4310000 2.6790000 18.7520000 - 149 149 1 0.0000000 21.4310000 2.6790000 24.1090000 - 150 150 1 0.0000000 21.4310000 2.6790000 29.4670000 - 151 151 1 0.0000000 21.4310000 8.0360000 2.6790000 - 152 152 1 0.0000000 21.4310000 8.0360000 8.0360000 - 153 153 1 0.0000000 21.4310000 8.0360000 13.3940000 - 154 154 1 0.0000000 21.4310000 8.0360000 18.7520000 - 155 155 1 0.0000000 21.4310000 8.0360000 24.1090000 - 156 156 1 0.0000000 21.4310000 8.0360000 29.4670000 - 157 157 1 0.0000000 21.4310000 13.3940000 2.6790000 - 158 158 1 0.0000000 21.4310000 13.3940000 8.0360000 - 159 159 1 0.0000000 21.4310000 13.3940000 13.3940000 - 160 160 1 0.0000000 21.4310000 13.3940000 18.7520000 - 161 161 1 0.0000000 21.4310000 13.3940000 24.1090000 - 162 162 1 0.0000000 21.4310000 13.3940000 29.4670000 - 163 163 1 0.0000000 21.4310000 18.7520000 2.6790000 - 164 164 1 0.0000000 21.4310000 18.7520000 8.0360000 - 165 165 1 0.0000000 21.4310000 18.7520000 13.3940000 - 166 166 1 0.0000000 21.4310000 18.7520000 18.7520000 - 167 167 1 0.0000000 21.4310000 18.7520000 24.1090000 - 168 168 1 0.0000000 21.4310000 18.7520000 29.4670000 - 169 169 1 0.0000000 21.4310000 24.1090000 2.6790000 - 170 170 1 0.0000000 21.4310000 24.1090000 8.0360000 - 171 171 1 0.0000000 21.4310000 24.1090000 13.3940000 - 172 172 1 0.0000000 21.4310000 24.1090000 18.7520000 - 173 173 1 0.0000000 21.4310000 24.1090000 24.1090000 - 174 174 1 0.0000000 21.4310000 24.1090000 29.4670000 - 175 175 1 0.0000000 21.4310000 29.4670000 2.6790000 - 176 176 1 0.0000000 21.4310000 29.4670000 8.0360000 - 177 177 1 0.0000000 21.4310000 29.4670000 13.3940000 - 178 178 1 0.0000000 21.4310000 29.4670000 18.7520000 - 179 179 1 0.0000000 21.4310000 29.4670000 24.1090000 - 180 180 1 0.0000000 21.4310000 29.4670000 29.4670000 - 181 181 1 0.0000000 26.7880000 2.6790000 2.6790000 - 182 182 1 0.0000000 26.7880000 2.6790000 8.0360000 - 183 183 1 0.0000000 26.7880000 2.6790000 13.3940000 - 184 184 1 0.0000000 26.7880000 2.6790000 18.7520000 - 185 185 1 0.0000000 26.7880000 2.6790000 24.1090000 - 186 186 1 0.0000000 26.7880000 2.6790000 29.4670000 - 187 187 1 0.0000000 26.7880000 8.0360000 2.6790000 - 188 188 1 0.0000000 26.7880000 8.0360000 8.0360000 - 189 189 1 0.0000000 26.7880000 8.0360000 13.3940000 - 190 190 1 0.0000000 26.7880000 8.0360000 18.7520000 - 191 191 1 0.0000000 26.7880000 8.0360000 24.1090000 - 192 192 1 0.0000000 26.7880000 8.0360000 29.4670000 - 193 193 1 0.0000000 26.7880000 13.3940000 2.6790000 - 194 194 1 0.0000000 26.7880000 13.3940000 8.0360000 - 195 195 1 0.0000000 26.7880000 13.3940000 13.3940000 - 196 196 1 0.0000000 26.7880000 13.3940000 18.7520000 - 197 197 1 0.0000000 26.7880000 13.3940000 24.1090000 - 198 198 1 0.0000000 26.7880000 13.3940000 29.4670000 - 199 199 1 0.0000000 26.7880000 18.7520000 2.6790000 - 200 200 1 0.0000000 26.7880000 18.7520000 8.0360000 - 201 201 1 0.0000000 26.7880000 18.7520000 13.3940000 - 202 202 1 0.0000000 26.7880000 18.7520000 18.7520000 - 203 203 1 0.0000000 26.7880000 18.7520000 24.1090000 - 204 204 1 0.0000000 26.7880000 18.7520000 29.4670000 - 205 205 1 0.0000000 26.7880000 24.1090000 2.6790000 - 206 206 1 0.0000000 26.7880000 24.1090000 8.0360000 - 207 207 1 0.0000000 26.7880000 24.1090000 13.3940000 - 208 208 1 0.0000000 26.7880000 24.1090000 18.7520000 - 209 209 1 0.0000000 26.7880000 24.1090000 24.1090000 - 210 210 1 0.0000000 26.7880000 24.1090000 29.4670000 - 211 211 1 0.0000000 26.7880000 29.4670000 2.6790000 - 212 212 1 0.0000000 26.7880000 29.4670000 8.0360000 - 213 213 1 0.0000000 26.7880000 29.4670000 13.3940000 - 214 214 1 0.0000000 26.7880000 29.4670000 18.7520000 - 215 215 1 0.0000000 26.7880000 29.4670000 24.1090000 - 216 216 1 0.0000000 26.7880000 29.4670000 29.4670000 - 217 217 1 0.0000000 2.6790000 5.3580000 2.6790000 - 218 218 1 0.0000000 2.6790000 5.3580000 8.0360000 - 219 219 1 0.0000000 2.6790000 5.3580000 13.3940000 - 220 220 1 0.0000000 2.6790000 5.3580000 18.7520000 - 221 221 1 0.0000000 2.6790000 5.3580000 24.1090000 - 222 222 1 0.0000000 2.6790000 5.3580000 29.4670000 - 223 223 1 0.0000000 2.6790000 10.7150000 2.6790000 - 224 224 1 0.0000000 2.6790000 10.7150000 8.0360000 - 225 225 1 0.0000000 2.6790000 10.7150000 13.3940000 - 226 226 1 0.0000000 2.6790000 10.7150000 18.7520000 - 227 227 1 0.0000000 2.6790000 10.7150000 24.1090000 - 228 228 1 0.0000000 2.6790000 10.7150000 29.4670000 - 229 229 1 0.0000000 2.6790000 16.0730000 2.6790000 - 230 230 1 0.0000000 2.6790000 16.0730000 8.0360000 - 231 231 1 0.0000000 2.6790000 16.0730000 13.3940000 - 232 232 1 0.0000000 2.6790000 16.0730000 18.7520000 - 233 233 1 0.0000000 2.6790000 16.0730000 24.1090000 - 234 234 1 0.0000000 2.6790000 16.0730000 29.4670000 - 235 235 1 0.0000000 2.6790000 21.4310000 2.6790000 - 236 236 1 0.0000000 2.6790000 21.4310000 8.0360000 - 237 237 1 0.0000000 2.6790000 21.4310000 13.3940000 - 238 238 1 0.0000000 2.6790000 21.4310000 18.7520000 - 239 239 1 0.0000000 2.6790000 21.4310000 24.1090000 - 240 240 1 0.0000000 2.6790000 21.4310000 29.4670000 - 241 241 1 0.0000000 2.6790000 26.7880000 2.6790000 - 242 242 1 0.0000000 2.6790000 26.7880000 8.0360000 - 243 243 1 0.0000000 2.6790000 26.7880000 13.3940000 - 244 244 1 0.0000000 2.6790000 26.7880000 18.7520000 - 245 245 1 0.0000000 2.6790000 26.7880000 24.1090000 - 246 246 1 0.0000000 2.6790000 26.7880000 29.4670000 - 247 247 1 0.0000000 2.6790000 32.1460000 2.6790000 - 248 248 1 0.0000000 2.6790000 32.1460000 8.0360000 - 249 249 1 0.0000000 2.6790000 32.1460000 13.3940000 - 250 250 1 0.0000000 2.6790000 32.1460000 18.7520000 - 251 251 1 0.0000000 2.6790000 32.1460000 24.1090000 - 252 252 1 0.0000000 2.6790000 32.1460000 29.4670000 - 253 253 1 0.0000000 8.0360000 5.3580000 2.6790000 - 254 254 1 0.0000000 8.0360000 5.3580000 8.0360000 - 255 255 1 0.0000000 8.0360000 5.3580000 13.3940000 - 256 256 1 0.0000000 8.0360000 5.3580000 18.7520000 - 257 257 1 0.0000000 8.0360000 5.3580000 24.1090000 - 258 258 1 0.0000000 8.0360000 5.3580000 29.4670000 - 259 259 1 0.0000000 8.0360000 10.7150000 2.6790000 - 260 260 1 0.0000000 8.0360000 10.7150000 8.0360000 - 261 261 1 0.0000000 8.0360000 10.7150000 13.3940000 - 262 262 1 0.0000000 8.0360000 10.7150000 18.7520000 - 263 263 1 0.0000000 8.0360000 10.7150000 24.1090000 - 264 264 1 0.0000000 8.0360000 10.7150000 29.4670000 - 265 265 1 0.0000000 8.0360000 16.0730000 2.6790000 - 266 266 1 0.0000000 8.0360000 16.0730000 8.0360000 - 267 267 1 0.0000000 8.0360000 16.0730000 13.3940000 - 268 268 1 0.0000000 8.0360000 16.0730000 18.7520000 - 269 269 1 0.0000000 8.0360000 16.0730000 24.1090000 - 270 270 1 0.0000000 8.0360000 16.0730000 29.4670000 - 271 271 1 0.0000000 8.0360000 21.4310000 2.6790000 - 272 272 1 0.0000000 8.0360000 21.4310000 8.0360000 - 273 273 1 0.0000000 8.0360000 21.4310000 13.3940000 - 274 274 1 0.0000000 8.0360000 21.4310000 18.7520000 - 275 275 1 0.0000000 8.0360000 21.4310000 24.1090000 - 276 276 1 0.0000000 8.0360000 21.4310000 29.4670000 - 277 277 1 0.0000000 8.0360000 26.7880000 2.6790000 - 278 278 1 0.0000000 8.0360000 26.7880000 8.0360000 - 279 279 1 0.0000000 8.0360000 26.7880000 13.3940000 - 280 280 1 0.0000000 8.0360000 26.7880000 18.7520000 - 281 281 1 0.0000000 8.0360000 26.7880000 24.1090000 - 282 282 1 0.0000000 8.0360000 26.7880000 29.4670000 - 283 283 1 0.0000000 8.0360000 32.1460000 2.6790000 - 284 284 1 0.0000000 8.0360000 32.1460000 8.0360000 - 285 285 1 0.0000000 8.0360000 32.1460000 13.3940000 - 286 286 1 0.0000000 8.0360000 32.1460000 18.7520000 - 287 287 1 0.0000000 8.0360000 32.1460000 24.1090000 - 288 288 1 0.0000000 8.0360000 32.1460000 29.4670000 - 289 289 1 0.0000000 13.3940000 5.3580000 2.6790000 - 290 290 1 0.0000000 13.3940000 5.3580000 8.0360000 - 291 291 1 0.0000000 13.3940000 5.3580000 13.3940000 - 292 292 1 0.0000000 13.3940000 5.3580000 18.7520000 - 293 293 1 0.0000000 13.3940000 5.3580000 24.1090000 - 294 294 1 0.0000000 13.3940000 5.3580000 29.4670000 - 295 295 1 0.0000000 13.3940000 10.7150000 2.6790000 - 296 296 1 0.0000000 13.3940000 10.7150000 8.0360000 - 297 297 1 0.0000000 13.3940000 10.7150000 13.3940000 - 298 298 1 0.0000000 13.3940000 10.7150000 18.7520000 - 299 299 1 0.0000000 13.3940000 10.7150000 24.1090000 - 300 300 1 0.0000000 13.3940000 10.7150000 29.4670000 - 301 301 1 0.0000000 13.3940000 16.0730000 2.6790000 - 302 302 1 0.0000000 13.3940000 16.0730000 8.0360000 - 303 303 1 0.0000000 13.3940000 16.0730000 13.3940000 - 304 304 1 0.0000000 13.3940000 16.0730000 18.7520000 - 305 305 1 0.0000000 13.3940000 16.0730000 24.1090000 - 306 306 1 0.0000000 13.3940000 16.0730000 29.4670000 - 307 307 1 0.0000000 13.3940000 21.4310000 2.6790000 - 308 308 1 0.0000000 13.3940000 21.4310000 8.0360000 - 309 309 1 0.0000000 13.3940000 21.4310000 13.3940000 - 310 310 1 0.0000000 13.3940000 21.4310000 18.7520000 - 311 311 1 0.0000000 13.3940000 21.4310000 24.1090000 - 312 312 1 0.0000000 13.3940000 21.4310000 29.4670000 - 313 313 1 0.0000000 13.3940000 26.7880000 2.6790000 - 314 314 1 0.0000000 13.3940000 26.7880000 8.0360000 - 315 315 1 0.0000000 13.3940000 26.7880000 13.3940000 - 316 316 1 0.0000000 13.3940000 26.7880000 18.7520000 - 317 317 1 0.0000000 13.3940000 26.7880000 24.1090000 - 318 318 1 0.0000000 13.3940000 26.7880000 29.4670000 - 319 319 1 0.0000000 13.3940000 32.1460000 2.6790000 - 320 320 1 0.0000000 13.3940000 32.1460000 8.0360000 - 321 321 1 0.0000000 13.3940000 32.1460000 13.3940000 - 322 322 1 0.0000000 13.3940000 32.1460000 18.7520000 - 323 323 1 0.0000000 13.3940000 32.1460000 24.1090000 - 324 324 1 0.0000000 13.3940000 32.1460000 29.4670000 - 325 325 1 0.0000000 18.7520000 5.3580000 2.6790000 - 326 326 1 0.0000000 18.7520000 5.3580000 8.0360000 - 327 327 1 0.0000000 18.7520000 5.3580000 13.3940000 - 328 328 1 0.0000000 18.7520000 5.3580000 18.7520000 - 329 329 1 0.0000000 18.7520000 5.3580000 24.1090000 - 330 330 1 0.0000000 18.7520000 5.3580000 29.4670000 - 331 331 1 0.0000000 18.7520000 10.7150000 2.6790000 - 332 332 1 0.0000000 18.7520000 10.7150000 8.0360000 - 333 333 1 0.0000000 18.7520000 10.7150000 13.3940000 - 334 334 1 0.0000000 18.7520000 10.7150000 18.7520000 - 335 335 1 0.0000000 18.7520000 10.7150000 24.1090000 - 336 336 1 0.0000000 18.7520000 10.7150000 29.4670000 - 337 337 1 0.0000000 18.7520000 16.0730000 2.6790000 - 338 338 1 0.0000000 18.7520000 16.0730000 8.0360000 - 339 339 1 0.0000000 18.7520000 16.0730000 13.3940000 - 340 340 1 0.0000000 18.7520000 16.0730000 18.7520000 - 341 341 1 0.0000000 18.7520000 16.0730000 24.1090000 - 342 342 1 0.0000000 18.7520000 16.0730000 29.4670000 - 343 343 1 0.0000000 18.7520000 21.4310000 2.6790000 - 344 344 1 0.0000000 18.7520000 21.4310000 8.0360000 - 345 345 1 0.0000000 18.7520000 21.4310000 13.3940000 - 346 346 1 0.0000000 18.7520000 21.4310000 18.7520000 - 347 347 1 0.0000000 18.7520000 21.4310000 24.1090000 - 348 348 1 0.0000000 18.7520000 21.4310000 29.4670000 - 349 349 1 0.0000000 18.7520000 26.7880000 2.6790000 - 350 350 1 0.0000000 18.7520000 26.7880000 8.0360000 - 351 351 1 0.0000000 18.7520000 26.7880000 13.3940000 - 352 352 1 0.0000000 18.7520000 26.7880000 18.7520000 - 353 353 1 0.0000000 18.7520000 26.7880000 24.1090000 - 354 354 1 0.0000000 18.7520000 26.7880000 29.4670000 - 355 355 1 0.0000000 18.7520000 32.1460000 2.6790000 - 356 356 1 0.0000000 18.7520000 32.1460000 8.0360000 - 357 357 1 0.0000000 18.7520000 32.1460000 13.3940000 - 358 358 1 0.0000000 18.7520000 32.1460000 18.7520000 - 359 359 1 0.0000000 18.7520000 32.1460000 24.1090000 - 360 360 1 0.0000000 18.7520000 32.1460000 29.4670000 - 361 361 1 0.0000000 24.1090000 5.3580000 2.6790000 - 362 362 1 0.0000000 24.1090000 5.3580000 8.0360000 - 363 363 1 0.0000000 24.1090000 5.3580000 13.3940000 - 364 364 1 0.0000000 24.1090000 5.3580000 18.7520000 - 365 365 1 0.0000000 24.1090000 5.3580000 24.1090000 - 366 366 1 0.0000000 24.1090000 5.3580000 29.4670000 - 367 367 1 0.0000000 24.1090000 10.7150000 2.6790000 - 368 368 1 0.0000000 24.1090000 10.7150000 8.0360000 - 369 369 1 0.0000000 24.1090000 10.7150000 13.3940000 - 370 370 1 0.0000000 24.1090000 10.7150000 18.7520000 - 371 371 1 0.0000000 24.1090000 10.7150000 24.1090000 - 372 372 1 0.0000000 24.1090000 10.7150000 29.4670000 - 373 373 1 0.0000000 24.1090000 16.0730000 2.6790000 - 374 374 1 0.0000000 24.1090000 16.0730000 8.0360000 - 375 375 1 0.0000000 24.1090000 16.0730000 13.3940000 - 376 376 1 0.0000000 24.1090000 16.0730000 18.7520000 - 377 377 1 0.0000000 24.1090000 16.0730000 24.1090000 - 378 378 1 0.0000000 24.1090000 16.0730000 29.4670000 - 379 379 1 0.0000000 24.1090000 21.4310000 2.6790000 - 380 380 1 0.0000000 24.1090000 21.4310000 8.0360000 - 381 381 1 0.0000000 24.1090000 21.4310000 13.3940000 - 382 382 1 0.0000000 24.1090000 21.4310000 18.7520000 - 383 383 1 0.0000000 24.1090000 21.4310000 24.1090000 - 384 384 1 0.0000000 24.1090000 21.4310000 29.4670000 - 385 385 1 0.0000000 24.1090000 26.7880000 2.6790000 - 386 386 1 0.0000000 24.1090000 26.7880000 8.0360000 - 387 387 1 0.0000000 24.1090000 26.7880000 13.3940000 - 388 388 1 0.0000000 24.1090000 26.7880000 18.7520000 - 389 389 1 0.0000000 24.1090000 26.7880000 24.1090000 - 390 390 1 0.0000000 24.1090000 26.7880000 29.4670000 - 391 391 1 0.0000000 24.1090000 32.1460000 2.6790000 - 392 392 1 0.0000000 24.1090000 32.1460000 8.0360000 - 393 393 1 0.0000000 24.1090000 32.1460000 13.3940000 - 394 394 1 0.0000000 24.1090000 32.1460000 18.7520000 - 395 395 1 0.0000000 24.1090000 32.1460000 24.1090000 - 396 396 1 0.0000000 24.1090000 32.1460000 29.4670000 - 397 397 1 0.0000000 29.4670000 5.3580000 2.6790000 - 398 398 1 0.0000000 29.4670000 5.3580000 8.0360000 - 399 399 1 0.0000000 29.4670000 5.3580000 13.3940000 - 400 400 1 0.0000000 29.4670000 5.3580000 18.7520000 - 401 401 1 0.0000000 29.4670000 5.3580000 24.1090000 - 402 402 1 0.0000000 29.4670000 5.3580000 29.4670000 - 403 403 1 0.0000000 29.4670000 10.7150000 2.6790000 - 404 404 1 0.0000000 29.4670000 10.7150000 8.0360000 - 405 405 1 0.0000000 29.4670000 10.7150000 13.3940000 - 406 406 1 0.0000000 29.4670000 10.7150000 18.7520000 - 407 407 1 0.0000000 29.4670000 10.7150000 24.1090000 - 408 408 1 0.0000000 29.4670000 10.7150000 29.4670000 - 409 409 1 0.0000000 29.4670000 16.0730000 2.6790000 - 410 410 1 0.0000000 29.4670000 16.0730000 8.0360000 - 411 411 1 0.0000000 29.4670000 16.0730000 13.3940000 - 412 412 1 0.0000000 29.4670000 16.0730000 18.7520000 - 413 413 1 0.0000000 29.4670000 16.0730000 24.1090000 - 414 414 1 0.0000000 29.4670000 16.0730000 29.4670000 - 415 415 1 0.0000000 29.4670000 21.4310000 2.6790000 - 416 416 1 0.0000000 29.4670000 21.4310000 8.0360000 - 417 417 1 0.0000000 29.4670000 21.4310000 13.3940000 - 418 418 1 0.0000000 29.4670000 21.4310000 18.7520000 - 419 419 1 0.0000000 29.4670000 21.4310000 24.1090000 - 420 420 1 0.0000000 29.4670000 21.4310000 29.4670000 - 421 421 1 0.0000000 29.4670000 26.7880000 2.6790000 - 422 422 1 0.0000000 29.4670000 26.7880000 8.0360000 - 423 423 1 0.0000000 29.4670000 26.7880000 13.3940000 - 424 424 1 0.0000000 29.4670000 26.7880000 18.7520000 - 425 425 1 0.0000000 29.4670000 26.7880000 24.1090000 - 426 426 1 0.0000000 29.4670000 26.7880000 29.4670000 - 427 427 1 0.0000000 29.4670000 32.1460000 2.6790000 - 428 428 1 0.0000000 29.4670000 32.1460000 8.0360000 - 429 429 1 0.0000000 29.4670000 32.1460000 13.3940000 - 430 430 1 0.0000000 29.4670000 32.1460000 18.7520000 - 431 431 1 0.0000000 29.4670000 32.1460000 24.1090000 - 432 432 1 0.0000000 29.4670000 32.1460000 29.4670000 - 433 433 1 0.0000000 2.6790000 2.6790000 5.3580000 - 434 434 1 0.0000000 2.6790000 2.6790000 10.7150000 - 435 435 1 0.0000000 2.6790000 2.6790000 16.0730000 - 436 436 1 0.0000000 2.6790000 2.6790000 21.4310000 - 437 437 1 0.0000000 2.6790000 2.6790000 26.7880000 - 438 438 1 0.0000000 2.6790000 2.6790000 32.1460000 - 439 439 1 0.0000000 2.6790000 8.0360000 5.3580000 - 440 440 1 0.0000000 2.6790000 8.0360000 10.7150000 - 441 441 1 0.0000000 2.6790000 8.0360000 16.0730000 - 442 442 1 0.0000000 2.6790000 8.0360000 21.4310000 - 443 443 1 0.0000000 2.6790000 8.0360000 26.7880000 - 444 444 1 0.0000000 2.6790000 8.0360000 32.1460000 - 445 445 1 0.0000000 2.6790000 13.3940000 5.3580000 - 446 446 1 0.0000000 2.6790000 13.3940000 10.7150000 - 447 447 1 0.0000000 2.6790000 13.3940000 16.0730000 - 448 448 1 0.0000000 2.6790000 13.3940000 21.4310000 - 449 449 1 0.0000000 2.6790000 13.3940000 26.7880000 - 450 450 1 0.0000000 2.6790000 13.3940000 32.1460000 - 451 451 1 0.0000000 2.6790000 18.7520000 5.3580000 - 452 452 1 0.0000000 2.6790000 18.7520000 10.7150000 - 453 453 1 0.0000000 2.6790000 18.7520000 16.0730000 - 454 454 1 0.0000000 2.6790000 18.7520000 21.4310000 - 455 455 1 0.0000000 2.6790000 18.7520000 26.7880000 - 456 456 1 0.0000000 2.6790000 18.7520000 32.1460000 - 457 457 1 0.0000000 2.6790000 24.1090000 5.3580000 - 458 458 1 0.0000000 2.6790000 24.1090000 10.7150000 - 459 459 1 0.0000000 2.6790000 24.1090000 16.0730000 - 460 460 1 0.0000000 2.6790000 24.1090000 21.4310000 - 461 461 1 0.0000000 2.6790000 24.1090000 26.7880000 - 462 462 1 0.0000000 2.6790000 24.1090000 32.1460000 - 463 463 1 0.0000000 2.6790000 29.4670000 5.3580000 - 464 464 1 0.0000000 2.6790000 29.4670000 10.7150000 - 465 465 1 0.0000000 2.6790000 29.4670000 16.0730000 - 466 466 1 0.0000000 2.6790000 29.4670000 21.4310000 - 467 467 1 0.0000000 2.6790000 29.4670000 26.7880000 - 468 468 1 0.0000000 2.6790000 29.4670000 32.1460000 - 469 469 1 0.0000000 8.0360000 2.6790000 5.3580000 - 470 470 1 0.0000000 8.0360000 2.6790000 10.7150000 - 471 471 1 0.0000000 8.0360000 2.6790000 16.0730000 - 472 472 1 0.0000000 8.0360000 2.6790000 21.4310000 - 473 473 1 0.0000000 8.0360000 2.6790000 26.7880000 - 474 474 1 0.0000000 8.0360000 2.6790000 32.1460000 - 475 475 1 0.0000000 8.0360000 8.0360000 5.3580000 - 476 476 1 0.0000000 8.0360000 8.0360000 10.7150000 - 477 477 1 0.0000000 8.0360000 8.0360000 16.0730000 - 478 478 1 0.0000000 8.0360000 8.0360000 21.4310000 - 479 479 1 0.0000000 8.0360000 8.0360000 26.7880000 - 480 480 1 0.0000000 8.0360000 8.0360000 32.1460000 - 481 481 1 0.0000000 8.0360000 13.3940000 5.3580000 - 482 482 1 0.0000000 8.0360000 13.3940000 10.7150000 - 483 483 1 0.0000000 8.0360000 13.3940000 16.0730000 - 484 484 1 0.0000000 8.0360000 13.3940000 21.4310000 - 485 485 1 0.0000000 8.0360000 13.3940000 26.7880000 - 486 486 1 0.0000000 8.0360000 13.3940000 32.1460000 - 487 487 1 0.0000000 8.0360000 18.7520000 5.3580000 - 488 488 1 0.0000000 8.0360000 18.7520000 10.7150000 - 489 489 1 0.0000000 8.0360000 18.7520000 16.0730000 - 490 490 1 0.0000000 8.0360000 18.7520000 21.4310000 - 491 491 1 0.0000000 8.0360000 18.7520000 26.7880000 - 492 492 1 0.0000000 8.0360000 18.7520000 32.1460000 - 493 493 1 0.0000000 8.0360000 24.1090000 5.3580000 - 494 494 1 0.0000000 8.0360000 24.1090000 10.7150000 - 495 495 1 0.0000000 8.0360000 24.1090000 16.0730000 - 496 496 1 0.0000000 8.0360000 24.1090000 21.4310000 - 497 497 1 0.0000000 8.0360000 24.1090000 26.7880000 - 498 498 1 0.0000000 8.0360000 24.1090000 32.1460000 - 499 499 1 0.0000000 8.0360000 29.4670000 5.3580000 - 500 500 1 0.0000000 8.0360000 29.4670000 10.7150000 - 501 501 1 0.0000000 8.0360000 29.4670000 16.0730000 - 502 502 1 0.0000000 8.0360000 29.4670000 21.4310000 - 503 503 1 0.0000000 8.0360000 29.4670000 26.7880000 - 504 504 1 0.0000000 8.0360000 29.4670000 32.1460000 - 505 505 1 0.0000000 13.3940000 2.6790000 5.3580000 - 506 506 1 0.0000000 13.3940000 2.6790000 10.7150000 - 507 507 1 0.0000000 13.3940000 2.6790000 16.0730000 - 508 508 1 0.0000000 13.3940000 2.6790000 21.4310000 - 509 509 1 0.0000000 13.3940000 2.6790000 26.7880000 - 510 510 1 0.0000000 13.3940000 2.6790000 32.1460000 - 511 511 1 0.0000000 13.3940000 8.0360000 5.3580000 - 512 512 1 0.0000000 13.3940000 8.0360000 10.7150000 - 513 513 1 0.0000000 13.3940000 8.0360000 16.0730000 - 514 514 1 0.0000000 13.3940000 8.0360000 21.4310000 - 515 515 1 0.0000000 13.3940000 8.0360000 26.7880000 - 516 516 1 0.0000000 13.3940000 8.0360000 32.1460000 - 517 517 1 0.0000000 13.3940000 13.3940000 5.3580000 - 518 518 1 0.0000000 13.3940000 13.3940000 10.7150000 - 519 519 1 0.0000000 13.3940000 13.3940000 16.0730000 - 520 520 1 0.0000000 13.3940000 13.3940000 21.4310000 - 521 521 1 0.0000000 13.3940000 13.3940000 26.7880000 - 522 522 1 0.0000000 13.3940000 13.3940000 32.1460000 - 523 523 1 0.0000000 13.3940000 18.7520000 5.3580000 - 524 524 1 0.0000000 13.3940000 18.7520000 10.7150000 - 525 525 1 0.0000000 13.3940000 18.7520000 16.0730000 - 526 526 1 0.0000000 13.3940000 18.7520000 21.4310000 - 527 527 1 0.0000000 13.3940000 18.7520000 26.7880000 - 528 528 1 0.0000000 13.3940000 18.7520000 32.1460000 - 529 529 1 0.0000000 13.3940000 24.1090000 5.3580000 - 530 530 1 0.0000000 13.3940000 24.1090000 10.7150000 - 531 531 1 0.0000000 13.3940000 24.1090000 16.0730000 - 532 532 1 0.0000000 13.3940000 24.1090000 21.4310000 - 533 533 1 0.0000000 13.3940000 24.1090000 26.7880000 - 534 534 1 0.0000000 13.3940000 24.1090000 32.1460000 - 535 535 1 0.0000000 13.3940000 29.4670000 5.3580000 - 536 536 1 0.0000000 13.3940000 29.4670000 10.7150000 - 537 537 1 0.0000000 13.3940000 29.4670000 16.0730000 - 538 538 1 0.0000000 13.3940000 29.4670000 21.4310000 - 539 539 1 0.0000000 13.3940000 29.4670000 26.7880000 - 540 540 1 0.0000000 13.3940000 29.4670000 32.1460000 - 541 541 1 0.0000000 18.7520000 2.6790000 5.3580000 - 542 542 1 0.0000000 18.7520000 2.6790000 10.7150000 - 543 543 1 0.0000000 18.7520000 2.6790000 16.0730000 - 544 544 1 0.0000000 18.7520000 2.6790000 21.4310000 - 545 545 1 0.0000000 18.7520000 2.6790000 26.7880000 - 546 546 1 0.0000000 18.7520000 2.6790000 32.1460000 - 547 547 1 0.0000000 18.7520000 8.0360000 5.3580000 - 548 548 1 0.0000000 18.7520000 8.0360000 10.7150000 - 549 549 1 0.0000000 18.7520000 8.0360000 16.0730000 - 550 550 1 0.0000000 18.7520000 8.0360000 21.4310000 - 551 551 1 0.0000000 18.7520000 8.0360000 26.7880000 - 552 552 1 0.0000000 18.7520000 8.0360000 32.1460000 - 553 553 1 0.0000000 18.7520000 13.3940000 5.3580000 - 554 554 1 0.0000000 18.7520000 13.3940000 10.7150000 - 555 555 1 0.0000000 18.7520000 13.3940000 16.0730000 - 556 556 1 0.0000000 18.7520000 13.3940000 21.4310000 - 557 557 1 0.0000000 18.7520000 13.3940000 26.7880000 - 558 558 1 0.0000000 18.7520000 13.3940000 32.1460000 - 559 559 1 0.0000000 18.7520000 18.7520000 5.3580000 - 560 560 1 0.0000000 18.7520000 18.7520000 10.7150000 - 561 561 1 0.0000000 18.7520000 18.7520000 16.0730000 - 562 562 1 0.0000000 18.7520000 18.7520000 21.4310000 - 563 563 1 0.0000000 18.7520000 18.7520000 26.7880000 - 564 564 1 0.0000000 18.7520000 18.7520000 32.1460000 - 565 565 1 0.0000000 18.7520000 24.1090000 5.3580000 - 566 566 1 0.0000000 18.7520000 24.1090000 10.7150000 - 567 567 1 0.0000000 18.7520000 24.1090000 16.0730000 - 568 568 1 0.0000000 18.7520000 24.1090000 21.4310000 - 569 569 1 0.0000000 18.7520000 24.1090000 26.7880000 - 570 570 1 0.0000000 18.7520000 24.1090000 32.1460000 - 571 571 1 0.0000000 18.7520000 29.4670000 5.3580000 - 572 572 1 0.0000000 18.7520000 29.4670000 10.7150000 - 573 573 1 0.0000000 18.7520000 29.4670000 16.0730000 - 574 574 1 0.0000000 18.7520000 29.4670000 21.4310000 - 575 575 1 0.0000000 18.7520000 29.4670000 26.7880000 - 576 576 1 0.0000000 18.7520000 29.4670000 32.1460000 - 577 577 1 0.0000000 24.1090000 2.6790000 5.3580000 - 578 578 1 0.0000000 24.1090000 2.6790000 10.7150000 - 579 579 1 0.0000000 24.1090000 2.6790000 16.0730000 - 580 580 1 0.0000000 24.1090000 2.6790000 21.4310000 - 581 581 1 0.0000000 24.1090000 2.6790000 26.7880000 - 582 582 1 0.0000000 24.1090000 2.6790000 32.1460000 - 583 583 1 0.0000000 24.1090000 8.0360000 5.3580000 - 584 584 1 0.0000000 24.1090000 8.0360000 10.7150000 - 585 585 1 0.0000000 24.1090000 8.0360000 16.0730000 - 586 586 1 0.0000000 24.1090000 8.0360000 21.4310000 - 587 587 1 0.0000000 24.1090000 8.0360000 26.7880000 - 588 588 1 0.0000000 24.1090000 8.0360000 32.1460000 - 589 589 1 0.0000000 24.1090000 13.3940000 5.3580000 - 590 590 1 0.0000000 24.1090000 13.3940000 10.7150000 - 591 591 1 0.0000000 24.1090000 13.3940000 16.0730000 - 592 592 1 0.0000000 24.1090000 13.3940000 21.4310000 - 593 593 1 0.0000000 24.1090000 13.3940000 26.7880000 - 594 594 1 0.0000000 24.1090000 13.3940000 32.1460000 - 595 595 1 0.0000000 24.1090000 18.7520000 5.3580000 - 596 596 1 0.0000000 24.1090000 18.7520000 10.7150000 - 597 597 1 0.0000000 24.1090000 18.7520000 16.0730000 - 598 598 1 0.0000000 24.1090000 18.7520000 21.4310000 - 599 599 1 0.0000000 24.1090000 18.7520000 26.7880000 - 600 600 1 0.0000000 24.1090000 18.7520000 32.1460000 - 601 601 1 0.0000000 24.1090000 24.1090000 5.3580000 - 602 602 1 0.0000000 24.1090000 24.1090000 10.7150000 - 603 603 1 0.0000000 24.1090000 24.1090000 16.0730000 - 604 604 1 0.0000000 24.1090000 24.1090000 21.4310000 - 605 605 1 0.0000000 24.1090000 24.1090000 26.7880000 - 606 606 1 0.0000000 24.1090000 24.1090000 32.1460000 - 607 607 1 0.0000000 24.1090000 29.4670000 5.3580000 - 608 608 1 0.0000000 24.1090000 29.4670000 10.7150000 - 609 609 1 0.0000000 24.1090000 29.4670000 16.0730000 - 610 610 1 0.0000000 24.1090000 29.4670000 21.4310000 - 611 611 1 0.0000000 24.1090000 29.4670000 26.7880000 - 612 612 1 0.0000000 24.1090000 29.4670000 32.1460000 - 613 613 1 0.0000000 29.4670000 2.6790000 5.3580000 - 614 614 1 0.0000000 29.4670000 2.6790000 10.7150000 - 615 615 1 0.0000000 29.4670000 2.6790000 16.0730000 - 616 616 1 0.0000000 29.4670000 2.6790000 21.4310000 - 617 617 1 0.0000000 29.4670000 2.6790000 26.7880000 - 618 618 1 0.0000000 29.4670000 2.6790000 32.1460000 - 619 619 1 0.0000000 29.4670000 8.0360000 5.3580000 - 620 620 1 0.0000000 29.4670000 8.0360000 10.7150000 - 621 621 1 0.0000000 29.4670000 8.0360000 16.0730000 - 622 622 1 0.0000000 29.4670000 8.0360000 21.4310000 - 623 623 1 0.0000000 29.4670000 8.0360000 26.7880000 - 624 624 1 0.0000000 29.4670000 8.0360000 32.1460000 - 625 625 1 0.0000000 29.4670000 13.3940000 5.3580000 - 626 626 1 0.0000000 29.4670000 13.3940000 10.7150000 - 627 627 1 0.0000000 29.4670000 13.3940000 16.0730000 - 628 628 1 0.0000000 29.4670000 13.3940000 21.4310000 - 629 629 1 0.0000000 29.4670000 13.3940000 26.7880000 - 630 630 1 0.0000000 29.4670000 13.3940000 32.1460000 - 631 631 1 0.0000000 29.4670000 18.7520000 5.3580000 - 632 632 1 0.0000000 29.4670000 18.7520000 10.7150000 - 633 633 1 0.0000000 29.4670000 18.7520000 16.0730000 - 634 634 1 0.0000000 29.4670000 18.7520000 21.4310000 - 635 635 1 0.0000000 29.4670000 18.7520000 26.7880000 - 636 636 1 0.0000000 29.4670000 18.7520000 32.1460000 - 637 637 1 0.0000000 29.4670000 24.1090000 5.3580000 - 638 638 1 0.0000000 29.4670000 24.1090000 10.7150000 - 639 639 1 0.0000000 29.4670000 24.1090000 16.0730000 - 640 640 1 0.0000000 29.4670000 24.1090000 21.4310000 - 641 641 1 0.0000000 29.4670000 24.1090000 26.7880000 - 642 642 1 0.0000000 29.4670000 24.1090000 32.1460000 - 643 643 1 0.0000000 29.4670000 29.4670000 5.3580000 - 644 644 1 0.0000000 29.4670000 29.4670000 10.7150000 - 645 645 1 0.0000000 29.4670000 29.4670000 16.0730000 - 646 646 1 0.0000000 29.4670000 29.4670000 21.4310000 - 647 647 1 0.0000000 29.4670000 29.4670000 26.7880000 - 648 648 1 0.0000000 29.4670000 29.4670000 32.1460000 - 649 649 1 0.0000000 0.0000000 5.3580000 5.3580000 - 650 650 1 0.0000000 0.0000000 5.3580000 10.7150000 - 651 651 1 0.0000000 0.0000000 5.3580000 16.0730000 - 652 652 1 0.0000000 0.0000000 5.3580000 21.4310000 - 653 653 1 0.0000000 0.0000000 5.3580000 26.7880000 - 654 654 1 0.0000000 0.0000000 5.3580000 32.1460000 - 655 655 1 0.0000000 0.0000000 10.7150000 5.3580000 - 656 656 1 0.0000000 0.0000000 10.7150000 10.7150000 - 657 657 1 0.0000000 0.0000000 10.7150000 16.0730000 - 658 658 1 0.0000000 0.0000000 10.7150000 21.4310000 - 659 659 1 0.0000000 0.0000000 10.7150000 26.7880000 - 660 660 1 0.0000000 0.0000000 10.7150000 32.1460000 - 661 661 1 0.0000000 0.0000000 16.0730000 5.3580000 - 662 662 1 0.0000000 0.0000000 16.0730000 10.7150000 - 663 663 1 0.0000000 0.0000000 16.0730000 16.0730000 - 664 664 1 0.0000000 0.0000000 16.0730000 21.4310000 - 665 665 1 0.0000000 0.0000000 16.0730000 26.7880000 - 666 666 1 0.0000000 0.0000000 16.0730000 32.1460000 - 667 667 1 0.0000000 0.0000000 21.4310000 5.3580000 - 668 668 1 0.0000000 0.0000000 21.4310000 10.7150000 - 669 669 1 0.0000000 0.0000000 21.4310000 16.0730000 - 670 670 1 0.0000000 0.0000000 21.4310000 21.4310000 - 671 671 1 0.0000000 0.0000000 21.4310000 26.7880000 - 672 672 1 0.0000000 0.0000000 21.4310000 32.1460000 - 673 673 1 0.0000000 0.0000000 26.7880000 5.3580000 - 674 674 1 0.0000000 0.0000000 26.7880000 10.7150000 - 675 675 1 0.0000000 0.0000000 26.7880000 16.0730000 - 676 676 1 0.0000000 0.0000000 26.7880000 21.4310000 - 677 677 1 0.0000000 0.0000000 26.7880000 26.7880000 - 678 678 1 0.0000000 0.0000000 26.7880000 32.1460000 - 679 679 1 0.0000000 0.0000000 32.1460000 5.3580000 - 680 680 1 0.0000000 0.0000000 32.1460000 10.7150000 - 681 681 1 0.0000000 0.0000000 32.1460000 16.0730000 - 682 682 1 0.0000000 0.0000000 32.1460000 21.4310000 - 683 683 1 0.0000000 0.0000000 32.1460000 26.7880000 - 684 684 1 0.0000000 0.0000000 32.1460000 32.1460000 - 685 685 1 0.0000000 5.3580000 5.3580000 5.3580000 - 686 686 1 0.0000000 5.3580000 5.3580000 10.7150000 - 687 687 1 0.0000000 5.3580000 5.3580000 16.0730000 - 688 688 1 0.0000000 5.3580000 5.3580000 21.4310000 - 689 689 1 0.0000000 5.3580000 5.3580000 26.7880000 - 690 690 1 0.0000000 5.3580000 5.3580000 32.1460000 - 691 691 1 0.0000000 5.3580000 10.7150000 5.3580000 - 692 692 1 0.0000000 5.3580000 10.7150000 10.7150000 - 693 693 1 0.0000000 5.3580000 10.7150000 16.0730000 - 694 694 1 0.0000000 5.3580000 10.7150000 21.4310000 - 695 695 1 0.0000000 5.3580000 10.7150000 26.7880000 - 696 696 1 0.0000000 5.3580000 10.7150000 32.1460000 - 697 697 1 0.0000000 5.3580000 16.0730000 5.3580000 - 698 698 1 0.0000000 5.3580000 16.0730000 10.7150000 - 699 699 1 0.0000000 5.3580000 16.0730000 16.0730000 - 700 700 1 0.0000000 5.3580000 16.0730000 21.4310000 - 701 701 1 0.0000000 5.3580000 16.0730000 26.7880000 - 702 702 1 0.0000000 5.3580000 16.0730000 32.1460000 - 703 703 1 0.0000000 5.3580000 21.4310000 5.3580000 - 704 704 1 0.0000000 5.3580000 21.4310000 10.7150000 - 705 705 1 0.0000000 5.3580000 21.4310000 16.0730000 - 706 706 1 0.0000000 5.3580000 21.4310000 21.4310000 - 707 707 1 0.0000000 5.3580000 21.4310000 26.7880000 - 708 708 1 0.0000000 5.3580000 21.4310000 32.1460000 - 709 709 1 0.0000000 5.3580000 26.7880000 5.3580000 - 710 710 1 0.0000000 5.3580000 26.7880000 10.7150000 - 711 711 1 0.0000000 5.3580000 26.7880000 16.0730000 - 712 712 1 0.0000000 5.3580000 26.7880000 21.4310000 - 713 713 1 0.0000000 5.3580000 26.7880000 26.7880000 - 714 714 1 0.0000000 5.3580000 26.7880000 32.1460000 - 715 715 1 0.0000000 5.3580000 32.1460000 5.3580000 - 716 716 1 0.0000000 5.3580000 32.1460000 10.7150000 - 717 717 1 0.0000000 5.3580000 32.1460000 16.0730000 - 718 718 1 0.0000000 5.3580000 32.1460000 21.4310000 - 719 719 1 0.0000000 5.3580000 32.1460000 26.7880000 - 720 720 1 0.0000000 5.3580000 32.1460000 32.1460000 - 721 721 1 0.0000000 10.7150000 5.3580000 5.3580000 - 722 722 1 0.0000000 10.7150000 5.3580000 10.7150000 - 723 723 1 0.0000000 10.7150000 5.3580000 16.0730000 - 724 724 1 0.0000000 10.7150000 5.3580000 21.4310000 - 725 725 1 0.0000000 10.7150000 5.3580000 26.7880000 - 726 726 1 0.0000000 10.7150000 5.3580000 32.1460000 - 727 727 1 0.0000000 10.7150000 10.7150000 5.3580000 - 728 728 1 0.0000000 10.7150000 10.7150000 10.7150000 - 729 729 1 0.0000000 10.7150000 10.7150000 16.0730000 - 730 730 1 0.0000000 10.7150000 10.7150000 21.4310000 - 731 731 1 0.0000000 10.7150000 10.7150000 26.7880000 - 732 732 1 0.0000000 10.7150000 10.7150000 32.1460000 - 733 733 1 0.0000000 10.7150000 16.0730000 5.3580000 - 734 734 1 0.0000000 10.7150000 16.0730000 10.7150000 - 735 735 1 0.0000000 10.7150000 16.0730000 16.0730000 - 736 736 1 0.0000000 10.7150000 16.0730000 21.4310000 - 737 737 1 0.0000000 10.7150000 16.0730000 26.7880000 - 738 738 1 0.0000000 10.7150000 16.0730000 32.1460000 - 739 739 1 0.0000000 10.7150000 21.4310000 5.3580000 - 740 740 1 0.0000000 10.7150000 21.4310000 10.7150000 - 741 741 1 0.0000000 10.7150000 21.4310000 16.0730000 - 742 742 1 0.0000000 10.7150000 21.4310000 21.4310000 - 743 743 1 0.0000000 10.7150000 21.4310000 26.7880000 - 744 744 1 0.0000000 10.7150000 21.4310000 32.1460000 - 745 745 1 0.0000000 10.7150000 26.7880000 5.3580000 - 746 746 1 0.0000000 10.7150000 26.7880000 10.7150000 - 747 747 1 0.0000000 10.7150000 26.7880000 16.0730000 - 748 748 1 0.0000000 10.7150000 26.7880000 21.4310000 - 749 749 1 0.0000000 10.7150000 26.7880000 26.7880000 - 750 750 1 0.0000000 10.7150000 26.7880000 32.1460000 - 751 751 1 0.0000000 10.7150000 32.1460000 5.3580000 - 752 752 1 0.0000000 10.7150000 32.1460000 10.7150000 - 753 753 1 0.0000000 10.7150000 32.1460000 16.0730000 - 754 754 1 0.0000000 10.7150000 32.1460000 21.4310000 - 755 755 1 0.0000000 10.7150000 32.1460000 26.7880000 - 756 756 1 0.0000000 10.7150000 32.1460000 32.1460000 - 757 757 1 0.0000000 16.0730000 5.3580000 5.3580000 - 758 758 1 0.0000000 16.0730000 5.3580000 10.7150000 - 759 759 1 0.0000000 16.0730000 5.3580000 16.0730000 - 760 760 1 0.0000000 16.0730000 5.3580000 21.4310000 - 761 761 1 0.0000000 16.0730000 5.3580000 26.7880000 - 762 762 1 0.0000000 16.0730000 5.3580000 32.1460000 - 763 763 1 0.0000000 16.0730000 10.7150000 5.3580000 - 764 764 1 0.0000000 16.0730000 10.7150000 10.7150000 - 765 765 1 0.0000000 16.0730000 10.7150000 16.0730000 - 766 766 1 0.0000000 16.0730000 10.7150000 21.4310000 - 767 767 1 0.0000000 16.0730000 10.7150000 26.7880000 - 768 768 1 0.0000000 16.0730000 10.7150000 32.1460000 - 769 769 1 0.0000000 16.0730000 16.0730000 5.3580000 - 770 770 1 0.0000000 16.0730000 16.0730000 10.7150000 - 771 771 1 0.0000000 16.0730000 16.0730000 16.0730000 - 772 772 1 0.0000000 16.0730000 16.0730000 21.4310000 - 773 773 1 0.0000000 16.0730000 16.0730000 26.7880000 - 774 774 1 0.0000000 16.0730000 16.0730000 32.1460000 - 775 775 1 0.0000000 16.0730000 21.4310000 5.3580000 - 776 776 1 0.0000000 16.0730000 21.4310000 10.7150000 - 777 777 1 0.0000000 16.0730000 21.4310000 16.0730000 - 778 778 1 0.0000000 16.0730000 21.4310000 21.4310000 - 779 779 1 0.0000000 16.0730000 21.4310000 26.7880000 - 780 780 1 0.0000000 16.0730000 21.4310000 32.1460000 - 781 781 1 0.0000000 16.0730000 26.7880000 5.3580000 - 782 782 1 0.0000000 16.0730000 26.7880000 10.7150000 - 783 783 1 0.0000000 16.0730000 26.7880000 16.0730000 - 784 784 1 0.0000000 16.0730000 26.7880000 21.4310000 - 785 785 1 0.0000000 16.0730000 26.7880000 26.7880000 - 786 786 1 0.0000000 16.0730000 26.7880000 32.1460000 - 787 787 1 0.0000000 16.0730000 32.1460000 5.3580000 - 788 788 1 0.0000000 16.0730000 32.1460000 10.7150000 - 789 789 1 0.0000000 16.0730000 32.1460000 16.0730000 - 790 790 1 0.0000000 16.0730000 32.1460000 21.4310000 - 791 791 1 0.0000000 16.0730000 32.1460000 26.7880000 - 792 792 1 0.0000000 16.0730000 32.1460000 32.1460000 - 793 793 1 0.0000000 21.4310000 5.3580000 5.3580000 - 794 794 1 0.0000000 21.4310000 5.3580000 10.7150000 - 795 795 1 0.0000000 21.4310000 5.3580000 16.0730000 - 796 796 1 0.0000000 21.4310000 5.3580000 21.4310000 - 797 797 1 0.0000000 21.4310000 5.3580000 26.7880000 - 798 798 1 0.0000000 21.4310000 5.3580000 32.1460000 - 799 799 1 0.0000000 21.4310000 10.7150000 5.3580000 - 800 800 1 0.0000000 21.4310000 10.7150000 10.7150000 - 801 801 1 0.0000000 21.4310000 10.7150000 16.0730000 - 802 802 1 0.0000000 21.4310000 10.7150000 21.4310000 - 803 803 1 0.0000000 21.4310000 10.7150000 26.7880000 - 804 804 1 0.0000000 21.4310000 10.7150000 32.1460000 - 805 805 1 0.0000000 21.4310000 16.0730000 5.3580000 - 806 806 1 0.0000000 21.4310000 16.0730000 10.7150000 - 807 807 1 0.0000000 21.4310000 16.0730000 16.0730000 - 808 808 1 0.0000000 21.4310000 16.0730000 21.4310000 - 809 809 1 0.0000000 21.4310000 16.0730000 26.7880000 - 810 810 1 0.0000000 21.4310000 16.0730000 32.1460000 - 811 811 1 0.0000000 21.4310000 21.4310000 5.3580000 - 812 812 1 0.0000000 21.4310000 21.4310000 10.7150000 - 813 813 1 0.0000000 21.4310000 21.4310000 16.0730000 - 814 814 1 0.0000000 21.4310000 21.4310000 21.4310000 - 815 815 1 0.0000000 21.4310000 21.4310000 26.7880000 - 816 816 1 0.0000000 21.4310000 21.4310000 32.1460000 - 817 817 1 0.0000000 21.4310000 26.7880000 5.3580000 - 818 818 1 0.0000000 21.4310000 26.7880000 10.7150000 - 819 819 1 0.0000000 21.4310000 26.7880000 16.0730000 - 820 820 1 0.0000000 21.4310000 26.7880000 21.4310000 - 821 821 1 0.0000000 21.4310000 26.7880000 26.7880000 - 822 822 1 0.0000000 21.4310000 26.7880000 32.1460000 - 823 823 1 0.0000000 21.4310000 32.1460000 5.3580000 - 824 824 1 0.0000000 21.4310000 32.1460000 10.7150000 - 825 825 1 0.0000000 21.4310000 32.1460000 16.0730000 - 826 826 1 0.0000000 21.4310000 32.1460000 21.4310000 - 827 827 1 0.0000000 21.4310000 32.1460000 26.7880000 - 828 828 1 0.0000000 21.4310000 32.1460000 32.1460000 - 829 829 1 0.0000000 26.7880000 5.3580000 5.3580000 - 830 830 1 0.0000000 26.7880000 5.3580000 10.7150000 - 831 831 1 0.0000000 26.7880000 5.3580000 16.0730000 - 832 832 1 0.0000000 26.7880000 5.3580000 21.4310000 - 833 833 1 0.0000000 26.7880000 5.3580000 26.7880000 - 834 834 1 0.0000000 26.7880000 5.3580000 32.1460000 - 835 835 1 0.0000000 26.7880000 10.7150000 5.3580000 - 836 836 1 0.0000000 26.7880000 10.7150000 10.7150000 - 837 837 1 0.0000000 26.7880000 10.7150000 16.0730000 - 838 838 1 0.0000000 26.7880000 10.7150000 21.4310000 - 839 839 1 0.0000000 26.7880000 10.7150000 26.7880000 - 840 840 1 0.0000000 26.7880000 10.7150000 32.1460000 - 841 841 1 0.0000000 26.7880000 16.0730000 5.3580000 - 842 842 1 0.0000000 26.7880000 16.0730000 10.7150000 - 843 843 1 0.0000000 26.7880000 16.0730000 16.0730000 - 844 844 1 0.0000000 26.7880000 16.0730000 21.4310000 - 845 845 1 0.0000000 26.7880000 16.0730000 26.7880000 - 846 846 1 0.0000000 26.7880000 16.0730000 32.1460000 - 847 847 1 0.0000000 26.7880000 21.4310000 5.3580000 - 848 848 1 0.0000000 26.7880000 21.4310000 10.7150000 - 849 849 1 0.0000000 26.7880000 21.4310000 16.0730000 - 850 850 1 0.0000000 26.7880000 21.4310000 21.4310000 - 851 851 1 0.0000000 26.7880000 21.4310000 26.7880000 - 852 852 1 0.0000000 26.7880000 21.4310000 32.1460000 - 853 853 1 0.0000000 26.7880000 26.7880000 5.3580000 - 854 854 1 0.0000000 26.7880000 26.7880000 10.7150000 - 855 855 1 0.0000000 26.7880000 26.7880000 16.0730000 - 856 856 1 0.0000000 26.7880000 26.7880000 21.4310000 - 857 857 1 0.0000000 26.7880000 26.7880000 26.7880000 - 858 858 1 0.0000000 26.7880000 26.7880000 32.1460000 - 859 859 1 0.0000000 26.7880000 32.1460000 5.3580000 - 860 860 1 0.0000000 26.7880000 32.1460000 10.7150000 - 861 861 1 0.0000000 26.7880000 32.1460000 16.0730000 - 862 862 1 0.0000000 26.7880000 32.1460000 21.4310000 - 863 863 1 0.0000000 26.7880000 32.1460000 26.7880000 - 864 864 1 0.0000000 26.7880000 32.1460000 32.1460000 - diff --git a/examples/python/gjf_python/ff-argon.lmp b/examples/python/gjf_python/ff-argon.lmp deleted file mode 100644 index b6f7bc931a..0000000000 --- a/examples/python/gjf_python/ff-argon.lmp +++ /dev/null @@ -1,20 +0,0 @@ -############################# -#Atoms types - mass - charge# -############################# -#@ 1 atom types #!THIS LINE IS NECESSARY DON'T SPEND HOURS FINDING THAT OUT!# - -variable Ar equal 1 - -############# -#Atom Masses# -############# - -mass ${Ar} 39.903 - -########################### -#Pair Potentials - Tersoff# -########################### - -pair_style lj/cubic -pair_coeff * * 0.0102701 3.42 - diff --git a/examples/python/gjf_python/gjf.py b/examples/python/gjf_python/gjf.py deleted file mode 100644 index 37fc28bb79..0000000000 --- a/examples/python/gjf_python/gjf.py +++ /dev/null @@ -1,180 +0,0 @@ -"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" - -from mpi4py import MPI -from lammps import lammps -import lammps_tools as lt -import numpy as np - -comm = MPI.COMM_WORLD -rank = comm.Get_rank() - -""" LAMMPS VARIABLES """ - -# new file or restart -run_no = 0 - -# data files -infile = "argon.lmp" -restart_file = "final_restart.{}".format(run_no) -ff_file = "ff-argon.lmp" -outfile = "output.dat" - -# write final_restart -write_final_restart = False - -# random numbers -seed0 = 2357 -seed1 = 26588 -seed2 = 10669 - -# MD Parameters -# number of steps -nsteps = 50000 -# timestep -# dt = 0.001 -# starting simulation temp -temp_start = 10 -# final simulation temp -temp_final = 10 -# relaxation time -trel = 1 -# trajectory frequency -ntraj = 0 - -# Ensemble 0 = GJF u, 1 = GJF v, 2 = Nose-Hoover, 3 = Langevin, 4 = BDP (Currently all NVT) -ensemble = 0 - -# Output Parameters -nthermo = 200 -nout = int(nsteps / nthermo) # Important - -# output to screen and log file? -lammps_output = False -# Lammps Thermo -thermo = False - -python_output = True - -# Write output to file? -write_output = False - -if write_output is True: - data = open("{}".format(outfile), "w") - -if python_output is True: - if rank == 0: - print("dt, temp, ke, fke, pe, fpe") - -for j in range(20): - - # timestep - dt = 0.005*(j+1) - - if lammps_output is True: - lmp = lammps() - else: - lmp = lammps(cmdargs=["-screen", "none", "-log", "none"]) - - lmp.command("atom_style full") - lmp.command("units metal") - lmp.command("processors * * *") - lmp.command("neighbor 1 bin") - lmp.command("boundary p p p") - - if run_no is 0: - lmp.command("read_data {}".format(infile)) - else: - lmp.command("read_restart final_restart".format(run_no-1)) - - if thermo is True: - lmp.command("thermo_style custom time temp pe ke press vol cpu") - lmp.command("thermo {}".format(nthermo)) - lmp.command("thermo_modify flush yes") - - lmp.file("{}".format(ff_file)) - lmp.command("timestep {}".format(dt)) - - # get_per_atom_compute example with dim of two and within a group - # lmp.command("region rand block 5 20 5 20 5 20") - # lmp.command("group rand region rand") - # lmp.command("compute x rand property/atom x y") - # test = get_per_atom_compute(comm, lmp, "x", 2, group="rand") - - lmp.command("compute ke all ke/atom") - - lmp.command("compute pe all pe") - - if ntraj != 0: - lmp.command("dump 1 all dcd {} trajectory.dcd".format(ntraj)) - lmp.command("dump_modify 1 unwrap yes") - - if run_no == 0: - lmp.command("velocity all create {} {} mom yes dist gaussian".format(temp_start, seed0)) - lmp.command("fix nve all nve") - - if ensemble == 0: - # gjf u - lmp.command("fix lang all langevin {} {} {} {} gjf yes halfstep yes".format( - temp_start, temp_final, trel, seed1)) - elif ensemble == 1: - # gjf v - lmp.command("fix lang all langevin {} {} {} {} gjf yes".format( - temp_start, temp_final, trel, seed1)) - elif ensemble == 2: - # NH - lmp.command("fix nvt all nvt temp {} {} {}".format( - temp_start, temp_final, trel)) - elif ensemble == 3: - # lang - lmp.command("fix lang all langevin {} {} {} {} tally yes zero yes".format( - temp_start, temp_final, trel, seed1)) - elif ensemble == 4: - # BDP - lmp.command("fix stoch all temp/csvr {} {} {} {}".format( - temp_start, temp_final, trel, seed1)) - - natoms = lmp.extract_global("natoms", 0) - nlocal = lmp.extract_global("nlocal", 0) - ke_sum = lt.get_per_atom_compute(comm, lmp, "ke") - ke_2 = ke_sum**2 - pe_sum = 0 - pe_2 = 0 - temp_sum = 0 - - for i in range(nout): - nlocal = lmp.extract_global("nlocal", 0) - lmp.command("run {} pre no post no".format(nthermo)) - temp = lmp.extract_compute("thermo_temp", 0, 0) - ke = lt.get_per_atom_compute(comm, lmp, "ke") - pe = lmp.extract_compute("pe", 0, 0) - ke_sum += ke - ke_2 += ke**2 - pe_sum += pe - pe_2 += pe**2 - temp_sum += temp - - if python_output is True: - if rank == 0: - print("Time: {:.6f}, Temp: {:.6f}, KE: {:.6f}, PE: {:.6f}".format( - i*nthermo*dt, temp, ke.sum(), pe)) - - if write_final_restart is True: - lmp.command("write_restart {}".format(restart_file)) - - if rank == 0: - ke = ke_sum.sum() / (nout + 1) - fke = (np.sqrt((ke_2 - ke_sum ** 2 / (nout + 1)) / (nout + 1))).sum() - pe = pe_sum / nout - fpe = np.sqrt((pe_2 - pe_sum ** 2 / nout) / nout) - temp = temp_sum / nout - - if python_output is True: - print(dt, temp, ke, fke, pe, fpe) - - if write_output is True: - data.write("{:.6f} {:.6f} {:.6f} {:.6f} {:.6f} {:.6f}\n".format( - dt, temp, ke, fke, pe, fpe)) - data.flush() - -if write_output is True: - data.close() diff --git a/examples/python/gjf_python/lammps_tools.py b/examples/python/gjf_python/lammps_tools.py deleted file mode 100644 index f9f25eaa28..0000000000 --- a/examples/python/gjf_python/lammps_tools.py +++ /dev/null @@ -1,78 +0,0 @@ -"""Made by Charlie Sievers Ph.D. Candidate, UC Davis, Donadio Lab 2019""" - -from mpi4py import MPI -import numpy as np -import ctypes as ctypes - -""" USEFULL LAMMPS FUNCTION """ - - -def get_nlocal(lmp): - - nlocal = lmp.extract_global("nlocal", 0) - - return nlocal - - -def get_aid(lmp, group=None): - - if group is None: - c_aid = lmp.extract_atom("id", 0) - ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_int32 * get_nlocal(lmp))) - aid = np.frombuffer(ptr.contents, dtype=np.int32) - else: - try: - c_aid = lmp.extract_variable("aid", group, 1) - ptr = ctypes.cast(c_aid, ctypes.POINTER(ctypes.c_double * get_nlocal(lmp))) - aid = np.frombuffer(ptr.contents, dtype=np.double) - except ValueError: - lmp.command("variable aid atom id") - aid = get_aid(lmp, group) - - return aid - - -def get_per_atom_compute(comm, lmp, name, dim=1, dtype="double", group=None): - laid = get_aid(lmp, group) - nlocal = get_nlocal(lmp) - ngroup = comm.allgather(laid) - type = dim - if dim > 1: - type = 2 - for array in ngroup: - try: - aid = np.concatenate((aid, array)) - except UnboundLocalError: - aid = array - if dtype == "double": - mem_type = ctypes.c_double - elif dtype == "integer": - mem_type = ctypes.c_int - elif dtype == "bigint": - mem_type = ctypes.c_int32 - else: - print("{} not implemented".format(dtype)) - return - - tmp = lmp.extract_compute(name, 1, type) - if type == 1: - ptr = ctypes.cast(tmp, ctypes.POINTER(mem_type * nlocal)) - else: - ptr = ctypes.cast(tmp[0], ctypes.POINTER(mem_type * nlocal * dim)) - lcompute = comm.allgather(np.frombuffer(ptr.contents).reshape((-1, dim))) - for array in lcompute: - try: - compute = np.concatenate((compute, array)) - except UnboundLocalError: - compute = array - - aid = np.expand_dims(aid, axis=1) - - compute = np.concatenate((aid, compute), axis=-1) - compute = compute[compute[..., 0] != 0] - compute = compute[compute[..., 0].argsort()][..., 1:] - - if dim == 1: - compute = np.squeeze(compute, axis=-1) - - return compute \ No newline at end of file diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index ea0929a236..36671ba6a4 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -18,11 +18,10 @@ Niels Gronbech-Jensen (UC Davis) GJF-2GJ Formulation ------------------------------------------------------------------------- */ +#include "fix_langevin.h" #include #include #include -#include -#include "fix_langevin.h" #include "math_extra.h" #include "atom.h" #include "atom_vec_ellipsoid.h" @@ -30,8 +29,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" @@ -55,7 +52,8 @@ enum{CONSTANT,EQUAL,ATOM}; FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : Fix(lmp, narg, arg), gjfflag(0), gfactor1(NULL), gfactor2(NULL), ratio(NULL), tstr(NULL), - flangevin(NULL), tforce(NULL), franprev(NULL), id_temp(NULL), random(NULL) + flangevin(NULL), tforce(NULL), franprev(NULL), id_temp(NULL), random(NULL), + lv(NULL), wildcard(NULL), bias(NULL) { if (narg < 7) error->all(FLERR,"Illegal fix langevin command"); @@ -112,7 +110,10 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : } else if (strcmp(arg[iarg],"gjf") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); if (strcmp(arg[iarg+1],"no") == 0) gjfflag = 0; - else if (strcmp(arg[iarg+1],"yes") == 0) gjfflag = 1; + else if (strcmp(arg[iarg+1],"yes") == 0) + error->all(FLERR,"GJF yes keyword is deprecated.\nPlease use vhalf or vfull."); + else if (strcmp(arg[iarg+1],"vfull") == 0) {gjfflag = 1; hsflag = 0;} + else if (strcmp(arg[iarg+1],"vhalf") == 0) {gjfflag = 1; hsflag = 1;} else error->all(FLERR,"Illegal fix langevin command"); iarg += 2; } else if (strcmp(arg[iarg],"omega") == 0) { @@ -141,14 +142,6 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : else if (strcmp(arg[iarg+1],"yes") == 0) zeroflag = 1; else error->all(FLERR,"Illegal fix langevin command"); iarg += 2; - } else if (strcmp(arg[iarg],"halfstep") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); - if (gjfflag == 0) error->all(FLERR,"GJF must be set"); - if (tallyflag == 0) error->warning(FLERR,"Careful, tally is untested"); - if (strcmp(arg[iarg+1],"no") == 0) hsflag = 0; - else if (strcmp(arg[iarg+1],"yes") == 0) hsflag = 1; - else error->all(FLERR,"Illegal fix langevin command"); - iarg += 2; } else error->all(FLERR,"Illegal fix langevin command"); } @@ -168,6 +161,7 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : franprev = NULL; wildcard = NULL; lv = NULL; + bias = NULL; tforce = NULL; maxatom1 = maxatom2 = 0; @@ -218,6 +212,7 @@ FixLangevin::~FixLangevin() memory->destroy(franprev); memory->destroy(wildcard); if (hsflag) memory->destroy(lv); + if (temperature && temperature->tempbias) memory->destroy(bias); atom->delete_callback(id,0); } } @@ -300,6 +295,9 @@ void FixLangevin::init() if (strstr(update->integrate_style,"respa")) nlevels_respa = ((Respa *) update->integrate)->nlevels; + if (strstr(update->integrate_style,"respa")) + error->one(FLERR,"Fix langevin gjf not implemented with respa capabilities"); + if (gjfflag) gjffac = 1.0/sqrt(1.0+update->dt/2.0/t_period); } @@ -331,6 +329,11 @@ void FixLangevin::setup(int vflag) wildcard[i][0] = v[i][0]; wildcard[i][1] = v[i][1]; wildcard[i][2] = v[i][2]; + if (tbiasflag == BIAS) { + bias[i][0] = 0.0; + bias[i][1] = 0.0; + bias[i][2] = 0.0; + } } } } @@ -357,34 +360,95 @@ void FixLangevin::post_integrate() int nlocal = atom->nlocal; if (igroup == atom->firstgroup) nlocal = atom->nfirst; + if (tbiasflag == BIAS) { + double b[3] = {0.0, 0.0, 0.0}; + for (int i = 0; i < nlocal; i++) { + bias[i][0] = v[i][0]; + bias[i][1] = v[i][1]; + bias[i][2] = v[i][2]; + v[i][0] = wildcard[i][0]; + v[i][1] = wildcard[i][1]; + v[i][2] = wildcard[i][2]; + } + temperature->compute_scalar(); + for (int i = 0; i < nlocal; i++) { + temperature->remove_bias(i, v[i]); + wildcard[i][0] = v[i][0]; + wildcard[i][1] = v[i][1]; + wildcard[i][2] = v[i][2]; + if (wildcard[i][0] == 0.0) franprev[i][0] = 0.0; + if (wildcard[i][1] == 0.0) franprev[i][1] = 0.0; + if (wildcard[i][2] == 0.0) franprev[i][2] = 0.0; + temperature->restore_bias(i, v[i]); + b[0] = v[i][0] - wildcard[i][0]; + b[1] = v[i][1] - wildcard[i][1]; + b[2] = v[i][2] - wildcard[i][2]; + v[i][0] = bias[i][0]; + v[i][1] = bias[i][1]; + v[i][2] = bias[i][2]; + bias[i][0] = b[0]; + bias[i][1] = b[1]; + bias[i][2] = b[2]; + } + } if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { dtfm = dtf / rmass[i]; - x[i][0] += -dt * v[i][0]; - x[i][1] += -dt * v[i][1]; - x[i][2] += -dt * v[i][2]; + x[i][0] -= dt * v[i][0]; + x[i][1] -= dt * v[i][1]; + x[i][2] -= dt * v[i][2]; v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + if (tbiasflag == BIAS) + for (int j = 0; j < 3; j++) { + if (wildcard[i][j] == 0) { + v[i][j] /= gjffac; + } + v[i][j] += bias[i][j]; + if (wildcard[i][j] == 0){ + v[i][j] /= gjffac; + } + } x[i][0] += gjffac * dt * v[i][0]; x[i][1] += gjffac * dt * v[i][1]; x[i][2] += gjffac * dt * v[i][2]; + if (tbiasflag == BIAS) + for (int j = 0; j < 3; j++) { + if (wildcard[i][j] == 0) + v[i][j] *= gjffac; + } } } else { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { dtfm = dtf / mass[type[i]]; - x[i][0] += -dt * v[i][0]; - x[i][1] += -dt * v[i][1]; - x[i][2] += -dt * v[i][2]; + x[i][0] -= dt * v[i][0]; + x[i][1] -= dt * v[i][1]; + x[i][2] -= dt * v[i][2]; v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); + if (tbiasflag == BIAS) + for (int j = 0; j < 3; j++) { + if (wildcard[i][j] == 0) { + v[i][j] /= gjffac; + } + v[i][j] += bias[i][j]; + if (wildcard[i][j] == 0){ + v[i][j] /= gjffac; + } + } x[i][0] += gjffac * dt * v[i][0]; x[i][1] += gjffac * dt * v[i][1]; x[i][2] += gjffac * dt * v[i][2]; + if (tbiasflag == BIAS) + for (int j = 0; j < 3; j++) { + if (wildcard[i][j] == 0) + v[i][j] *= gjffac; + } } } } @@ -657,9 +721,17 @@ void FixLangevin::post_force_templated() if (Tp_TALLY) { if (Tp_GJF && update->ntimestep != update->beginstep){ - fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; - fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; - fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; + if (Tp_BIAS) { + temperature->remove_bias(i,v[i]); + fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; + temperature->restore_bias(i,v[i]); + } else { + fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; + fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; + fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; + } fran[0] *= gjffac; fran[1] *= gjffac; fran[2] *= gjffac; @@ -894,8 +966,9 @@ void FixLangevin::end_of_step() v[i][2] = lv[i][2]; } } - energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + - flangevin[i][2] * v[i][2]; + if (tallyflag) + energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + + flangevin[i][2] * v[i][2]; } if (tallyflag) { energy += energy_onestep * update->dt; @@ -953,7 +1026,7 @@ int FixLangevin::modify_param(int narg, char **arg) double FixLangevin::compute_scalar() { - if (!tallyflag || !flangevin_allocated) return 0.0; + if (!tallyflag && !flangevin_allocated) return 0.0; // capture the very first energy transfer to thermal reservoir @@ -1004,6 +1077,7 @@ double FixLangevin::memory_usage() double bytes = 0.0; if (gjfflag) bytes += atom->nmax*3*2 * sizeof(double); if (gjfflag) if (hsflag) bytes += atom->nmax*3 * sizeof(double); + if (gjfflag && tbiasflag == BIAS) bytes += atom->nmax*3 * sizeof(double); if (tallyflag) bytes += atom->nmax*3 * sizeof(double); if (tforce) bytes += atom->nmax * sizeof(double); return bytes; @@ -1018,6 +1092,7 @@ void FixLangevin::grow_arrays(int nmax) memory->grow(franprev,nmax,3,"fix_langevin:franprev"); memory->grow(wildcard,nmax,3,"fix_langevin:wildcard"); if (hsflag) memory->grow(lv,nmax,3,"fix_langevin:lv"); + if (tbiasflag == BIAS) memory->grow(bias,nmax,3,"fix_langevin:bias"); } /* ---------------------------------------------------------------------- @@ -1037,6 +1112,11 @@ void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) lv[j][1] = lv[i][1]; lv[j][2] = lv[i][2]; } + if (tbiasflag == BIAS){ + bias[j][0] = bias[i][0]; + bias[j][1] = bias[i][1]; + bias[j][2] = bias[i][2]; + } } /* ---------------------------------------------------------------------- @@ -1057,6 +1137,11 @@ int FixLangevin::pack_exchange(int i, double *buf) buf[n++] = lv[i][1]; buf[n++] = lv[i][2]; } + if (tbiasflag == BIAS){ + buf[n++] = bias[i][0]; + buf[n++] = bias[i][1]; + buf[n++] = bias[i][2]; + } return n; } @@ -1078,5 +1163,10 @@ int FixLangevin::unpack_exchange(int nlocal, double *buf) lv[nlocal][1] = buf[n++]; lv[nlocal][2] = buf[n++]; } + if (tbiasflag == BIAS){ + bias[nlocal][0] = buf[n++]; + bias[nlocal][1] = buf[n++]; + bias[nlocal][2] = buf[n++]; + } return n; } diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 888734de04..1f9954153f 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -67,6 +67,7 @@ class FixLangevin : public Fix { double **franprev; double **lv; //2GJ velocity or half-step velocity double **wildcard; + double **bias; int nvalues; From 39050265c279ac662e5921ebb1afaa9ab26faeea Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Sun, 11 Aug 2019 20:23:57 -0700 Subject: [PATCH 090/557] Added gjf zero flag functionality and tbias functionality --- src/fix_langevin.cpp | 160 ++++++++++++++++++++++++++----------------- src/fix_langevin.h | 1 + 2 files changed, 99 insertions(+), 62 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 36671ba6a4..3dedce1b18 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -239,6 +239,8 @@ void FixLangevin::init() if (ascale && !atom->ellipsoid_flag) error->all(FLERR,"Fix langevin angmom requires atom style ellipsoid"); + if (gjfflag && zeroflag && tallyflag) + error->warning(FLERR,"Fix langevin gjf zero and tally were all set"); // check variable if (tstr) { @@ -315,24 +317,29 @@ void FixLangevin::setup(int vflag) } if (gjfflag) { - // update v of atoms in group double ** v = atom->v; double **f = atom->f; int nlocal = atom->nlocal; if (igroup == atom->firstgroup) nlocal = atom->nfirst; + double b[3] = {0.0,0.0,0.0}; for (int i = 0; i < nlocal; i++) { f[i][0] = wildcard[i][0]; f[i][1] = wildcard[i][1]; f[i][2] = wildcard[i][2]; + b[0] = v[i][0]; + b[1] = v[i][1]; + b[2] = v[i][2]; + if (tbiasflag == BIAS) temperature->remove_bias(i,v[i]); wildcard[i][0] = v[i][0]; wildcard[i][1] = v[i][1]; wildcard[i][2] = v[i][2]; if (tbiasflag == BIAS) { - bias[i][0] = 0.0; - bias[i][1] = 0.0; - bias[i][2] = 0.0; + temperature->restore_bias(i,v[i]); + bias[i][0] = b[0] - wildcard[i][0]; + bias[i][1] = b[1] - wildcard[i][1]; + bias[i][2] = b[2] - wildcard[i][2]; } } } @@ -360,37 +367,17 @@ void FixLangevin::post_integrate() int nlocal = atom->nlocal; if (igroup == atom->firstgroup) nlocal = atom->nfirst; - if (tbiasflag == BIAS) { - double b[3] = {0.0, 0.0, 0.0}; - for (int i = 0; i < nlocal; i++) { - bias[i][0] = v[i][0]; - bias[i][1] = v[i][1]; - bias[i][2] = v[i][2]; - v[i][0] = wildcard[i][0]; - v[i][1] = wildcard[i][1]; - v[i][2] = wildcard[i][2]; - } - temperature->compute_scalar(); - for (int i = 0; i < nlocal; i++) { - temperature->remove_bias(i, v[i]); - wildcard[i][0] = v[i][0]; - wildcard[i][1] = v[i][1]; - wildcard[i][2] = v[i][2]; - if (wildcard[i][0] == 0.0) franprev[i][0] = 0.0; - if (wildcard[i][1] == 0.0) franprev[i][1] = 0.0; - if (wildcard[i][2] == 0.0) franprev[i][2] = 0.0; - temperature->restore_bias(i, v[i]); - b[0] = v[i][0] - wildcard[i][0]; - b[1] = v[i][1] - wildcard[i][1]; - b[2] = v[i][2] - wildcard[i][2]; - v[i][0] = bias[i][0]; - v[i][1] = bias[i][1]; - v[i][2] = bias[i][2]; - bias[i][0] = b[0]; - bias[i][1] = b[1]; - bias[i][2] = b[2]; - } + // zero option + double vsum[3],vsumall[3]; + bigint count; + + if (zeroflag) { + vsum[0] = vsum[1] = vsum[2] = 0.0; + count = group->count(igroup); + if (count == 0) + error->all(FLERR,"Cannot zero Langevin force of 0 atoms"); } + if (rmass) { for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { @@ -404,11 +391,7 @@ void FixLangevin::post_integrate() if (tbiasflag == BIAS) for (int j = 0; j < 3; j++) { if (wildcard[i][j] == 0) { - v[i][j] /= gjffac; - } - v[i][j] += bias[i][j]; - if (wildcard[i][j] == 0){ - v[i][j] /= gjffac; + v[i][j] /= gjffac * gjffac; } } x[i][0] += gjffac * dt * v[i][0]; @@ -418,6 +401,8 @@ void FixLangevin::post_integrate() for (int j = 0; j < 3; j++) { if (wildcard[i][j] == 0) v[i][j] *= gjffac; + v[i][j] += bias[i][j]; + x[i][j] += dt * bias[i][j]; } } @@ -434,11 +419,7 @@ void FixLangevin::post_integrate() if (tbiasflag == BIAS) for (int j = 0; j < 3; j++) { if (wildcard[i][j] == 0) { - v[i][j] /= gjffac; - } - v[i][j] += bias[i][j]; - if (wildcard[i][j] == 0){ - v[i][j] /= gjffac; + v[i][j] /= gjffac*gjffac; } } x[i][0] += gjffac * dt * v[i][0]; @@ -446,11 +427,32 @@ void FixLangevin::post_integrate() x[i][2] += gjffac * dt * v[i][2]; if (tbiasflag == BIAS) for (int j = 0; j < 3; j++) { - if (wildcard[i][j] == 0) - v[i][j] *= gjffac; + if (wildcard[i][j] == 0) + v[i][j] *= gjffac; + v[i][j] += bias[i][j]; + x[i][j] += dt * bias[i][j]; } + if (zeroflag){ + vsum[0] += gjffac * dtfm * franprev[i][0]; + vsum[1] += gjffac * dtfm * franprev[i][1]; + vsum[2] += gjffac * dtfm * franprev[i][2]; + } } } + + if (zeroflag) { + MPI_Allreduce(vsum,vsumall,3,MPI_DOUBLE,MPI_SUM,world); + vsumall[0] /= count; + vsumall[1] /= count; + vsumall[2] /= count; + for (int i = 0; i < nlocal; i++) { + if (mask[i] & groupbit) { + v[i][0] -= vsumall[0]; + v[i][1] -= vsumall[1]; + v[i][2] -= vsumall[2]; + } + } + } } /* ---------------------------------------------------------------------- */ @@ -664,26 +666,34 @@ void FixLangevin::post_force_templated() flangevin_allocated = 1; } - if (Tp_BIAS) temperature->compute_scalar(); + if (Tp_BIAS && !gjfflag) temperature->compute_scalar(); + else if (Tp_BIAS && update->ntimestep == update->beginstep && gjfflag) temperature->compute_scalar(); for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; - gamma1 *= 1.0/ratio[type[i]]; - gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; + gamma2 = sqrt(rmass[i]) * sqrt(2.0 * boltz / t_period / dt / mvv2e) / ftm2v; + gamma1 *= 1.0 / ratio[type[i]]; + gamma2 *= 1.0 / sqrt(ratio[type[i]]) * tsqrt; } else { gamma1 = gfactor1[type[i]]; gamma2 = gfactor2[type[i]] * tsqrt; } - fran[0] = gamma2*random->gaussian(); - fran[1] = gamma2*random->gaussian(); - fran[2] = gamma2*random->gaussian(); + if (!gjfflag) { + fran[0] = gamma2 * random->uniform(); + fran[1] = gamma2 * random->uniform(); + fran[2] = gamma2 * random->uniform(); + } else { + fran[0] = gamma2 * random->gaussian(); + fran[1] = gamma2 * random->gaussian(); + fran[2] = gamma2 * random->gaussian(); + } if (Tp_BIAS) { + double b[3] = {0.0,0.0,0.0}; temperature->remove_bias(i,v[i]); fdrag[0] = gamma1*v[i][0]; fdrag[1] = gamma1*v[i][1]; @@ -693,9 +703,9 @@ void FixLangevin::post_force_templated() if (v[i][2] == 0.0) fran[2] = 0.0; temperature->restore_bias(i,v[i]); } else { - fdrag[0] = gamma1*v[i][0]; - fdrag[1] = gamma1*v[i][1]; - fdrag[2] = gamma1*v[i][2]; + fdrag[0] = gamma1*v[i][0];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][0]; + fdrag[1] = gamma1*v[i][1];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][1]; + fdrag[2] = gamma1*v[i][2];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][2]; } if (Tp_GJF) { @@ -706,13 +716,14 @@ void FixLangevin::post_force_templated() rantemp[0] = fran[0]; rantemp[1] = fran[1]; rantemp[2] = fran[2]; + fran[0] = franprev[i][0]; fran[1] = franprev[i][1]; fran[2] = franprev[i][2]; - fdrag[0] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; - fdrag[1] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; - fdrag[2] *= -2*t_period*(2*gjffac-1/gjffac-1)/dt; + fdrag[0] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; + fdrag[1] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; + fdrag[2] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; } f[i][0] += fdrag[0] + fran[0]; @@ -747,9 +758,16 @@ void FixLangevin::post_force_templated() } if (Tp_ZERO) { - fsum[0] += fran[0]; - fsum[1] += fran[1]; - fsum[2] += fran[2]; + if (!gjfflag){ + fsum[0] += fran[0]; + fsum[1] += fran[1]; + fsum[2] += fran[2]; + } + else { + fsum[0] += franprev[i][0]; + fsum[1] += franprev[i][1]; + fsum[2] += franprev[i][2]; + } } if (Tp_GJF) @@ -762,6 +780,11 @@ void FixLangevin::post_force_templated() lv[i][0] = v[i][0]; lv[i][1] = v[i][1]; lv[i][2] = v[i][2]; + if (tbiasflag == BIAS) { + lv[i][0] += bias[i][0]; + lv[i][1] += bias[i][1]; + lv[i][2] += bias[i][2]; + } } } } @@ -949,17 +972,30 @@ void FixLangevin::end_of_step() double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; + double b[3] = {0.0,0.0,0.0}; + + if (gjfflag && tbiasflag == BIAS) temperature->compute_scalar(); energy_onestep = 0.0; for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) { if (gjfflag){ + b[0] = v[i][0]; + b[1] = v[i][1]; + b[2] = v[i][2]; f[i][0] = wildcard[i][0]; f[i][1] = wildcard[i][1]; f[i][2] = wildcard[i][2]; + if (tbiasflag == BIAS) temperature->remove_bias(i,v[i]); wildcard[i][0] = v[i][0]; wildcard[i][1] = v[i][1]; wildcard[i][2] = v[i][2]; + if (tbiasflag == BIAS) { + bias[i][0] = b[0] - v[i][0]; + bias[i][1] = b[1] - v[i][1]; + bias[i][2] = b[2] - v[i][2]; + temperature->restore_bias(i, v[i]); + } if (hsflag){ v[i][0] = lv[i][0]; v[i][1] = lv[i][1]; diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 1f9954153f..9cd1ecb66a 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -68,6 +68,7 @@ class FixLangevin : public Fix { double **lv; //2GJ velocity or half-step velocity double **wildcard; double **bias; + double cm[3]; int nvalues; From 8078ac38493eb08d56f9c377c905ce7725ca6f00 Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Mon, 12 Aug 2019 15:32:13 -0700 Subject: [PATCH 091/557] cleaned up src files --- src/fix_langevin.cpp | 36 ++++++++++++++++++++++-------------- src/fix_langevin.h | 3 +-- 2 files changed, 23 insertions(+), 16 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index 3dedce1b18..c2e56881b7 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -240,7 +240,8 @@ void FixLangevin::init() error->all(FLERR,"Fix langevin angmom requires atom style ellipsoid"); if (gjfflag && zeroflag && tallyflag) - error->warning(FLERR,"Fix langevin gjf zero and tally were all set"); + error->warning(FLERR, + "Fix langevin: gjf, zero, and tally were all set correct energy tallying is not guaranteed"); // check variable if (tstr) { @@ -283,9 +284,14 @@ void FixLangevin::init() if (!atom->rmass) { for (int i = 1; i <= atom->ntypes; i++) { gfactor1[i] = -atom->mass[i] / t_period / force->ftm2v; - gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / - force->ftm2v; + if (gjfflag) + gfactor2[i] = sqrt(atom->mass[i]) * + sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / + force->ftm2v; + else + gfactor2[i] = sqrt(atom->mass[i]) * + sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / + force->ftm2v; gfactor1[i] *= 1.0/ratio[i]; gfactor2[i] *= 1.0/sqrt(ratio[i]); } @@ -674,7 +680,10 @@ void FixLangevin::post_force_templated() if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - gamma2 = sqrt(rmass[i]) * sqrt(2.0 * boltz / t_period / dt / mvv2e) / ftm2v; + if (gjfflag) + gamma2 = sqrt(rmass[i]) * sqrt(2.0 * boltz / t_period / dt / mvv2e) / ftm2v; + else + gamma2 = sqrt(rmass[i]) * sqrt(24.0 * boltz / t_period / dt / mvv2e) / ftm2v; gamma1 *= 1.0 / ratio[type[i]]; gamma2 *= 1.0 / sqrt(ratio[type[i]]) * tsqrt; } else { @@ -682,18 +691,17 @@ void FixLangevin::post_force_templated() gamma2 = gfactor2[type[i]] * tsqrt; } - if (!gjfflag) { - fran[0] = gamma2 * random->uniform(); - fran[1] = gamma2 * random->uniform(); - fran[2] = gamma2 * random->uniform(); - } else { + if (gjfflag) { fran[0] = gamma2 * random->gaussian(); fran[1] = gamma2 * random->gaussian(); fran[2] = gamma2 * random->gaussian(); + } else { + fran[0] = gamma2 * random->uniform(); + fran[1] = gamma2 * random->uniform(); + fran[2] = gamma2 * random->uniform(); } if (Tp_BIAS) { - double b[3] = {0.0,0.0,0.0}; temperature->remove_bias(i,v[i]); fdrag[0] = gamma1*v[i][0]; fdrag[1] = gamma1*v[i][1]; @@ -703,9 +711,9 @@ void FixLangevin::post_force_templated() if (v[i][2] == 0.0) fran[2] = 0.0; temperature->restore_bias(i,v[i]); } else { - fdrag[0] = gamma1*v[i][0];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][0]; - fdrag[1] = gamma1*v[i][1];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][1]; - fdrag[2] = gamma1*v[i][2];// - gjffac*(dtf / mass[type[i]])*gamma1*franprev[i][2]; + fdrag[0] = gamma1*v[i][0]; + fdrag[1] = gamma1*v[i][1]; + fdrag[2] = gamma1*v[i][2]; } if (Tp_GJF) { diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 9cd1ecb66a..939b161c35 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -67,8 +67,7 @@ class FixLangevin : public Fix { double **franprev; double **lv; //2GJ velocity or half-step velocity double **wildcard; - double **bias; - double cm[3]; + double **bias; //Bias velocity int nvalues; From f2068ece84baf0cf3b5fa0f28cba819b905ea814 Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Tue, 13 Aug 2019 16:06:17 -0700 Subject: [PATCH 092/557] restored regular langevin functionality --- src/fix_langevin.cpp | 12 ++++++------ 1 file changed, 6 insertions(+), 6 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index c2e56881b7..d323453cdb 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -680,7 +680,7 @@ void FixLangevin::post_force_templated() if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - if (gjfflag) + if (Tp_GJF) gamma2 = sqrt(rmass[i]) * sqrt(2.0 * boltz / t_period / dt / mvv2e) / ftm2v; else gamma2 = sqrt(rmass[i]) * sqrt(24.0 * boltz / t_period / dt / mvv2e) / ftm2v; @@ -691,14 +691,14 @@ void FixLangevin::post_force_templated() gamma2 = gfactor2[type[i]] * tsqrt; } - if (gjfflag) { + if (Tp_GJF) { fran[0] = gamma2 * random->gaussian(); fran[1] = gamma2 * random->gaussian(); fran[2] = gamma2 * random->gaussian(); } else { - fran[0] = gamma2 * random->uniform(); - fran[1] = gamma2 * random->uniform(); - fran[2] = gamma2 * random->uniform(); + fran[0] = gamma2 * (random->uniform()-0.5); + fran[1] = gamma2 * (random->uniform()-0.5); + fran[2] = gamma2 * (random->uniform()-0.5); } if (Tp_BIAS) { @@ -766,7 +766,7 @@ void FixLangevin::post_force_templated() } if (Tp_ZERO) { - if (!gjfflag){ + if (!Tp_GJF){ fsum[0] += fran[0]; fsum[1] += fran[1]; fsum[2] += fran[2]; From 37a046cf1eadee8d20fcfbaa6b744680bdbb0f68 Mon Sep 17 00:00:00 2001 From: "Jibril B. Coulibaly" <43829860+jibril-b-coulibaly@users.noreply.github.com> Date: Wed, 14 Aug 2019 17:39:56 -0500 Subject: [PATCH 093/557] Update pair_granular.cpp Modified PairGranular::single function to return the total normal force into argument fforce. This was done for pair styles gran/* but not for the granular pari_style, resulting in the variable fforce being uninitialized. --- src/GRANULAR/pair_granular.cpp | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index b87e64a456..2813035ebb 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -1630,7 +1630,11 @@ double PairGranular::single(int i, int j, int itype, int jtype, magtortwist = -Mtcrit * signtwist; // eq 34 } } - + + // set force and return no energy + + fforce = Fntot*rinv; + // set single_extra quantities svector[0] = fs1; From cc14103f28f65a8610780f6e1f73676214e95cca Mon Sep 17 00:00:00 2001 From: "Jibril B. Coulibaly" Date: Fri, 16 Aug 2019 15:22:15 -0500 Subject: [PATCH 094/557] Bug fixes in granular pair style: - correct formula for tangent forces in style with no history in compute() and in single() functions - remove tangent history update in the single() function - implement correct output for tangent, normal and rolling forces in single() function - correct typos in documentation --- doc/src/pair_granular.txt | 8 +++---- src/GRANULAR/pair_granular.cpp | 42 +++++++++++++++------------------- 2 files changed, 23 insertions(+), 27 deletions(-) diff --git a/doc/src/pair_granular.txt b/doc/src/pair_granular.txt index f16cd9fe0b..ccfe805b67 100644 --- a/doc/src/pair_granular.txt +++ b/doc/src/pair_granular.txt @@ -100,7 +100,7 @@ on particle {i} due to contact with particle {j} is given by: \mathbf\{F\}_\{ne, Hooke\} = k_N \delta_\{ij\} \mathbf\{n\} \end\{equation\} -Where \(\delta = R_i + R_j - \|\mathbf\{r\}_\{ij\}\|\) is the particle +Where \(\delta_\{ij\} = R_i + R_j - \|\mathbf\{r\}_\{ij\}\|\) is the particle overlap, \(R_i, R_j\) are the particle radii, \(\mathbf\{r\}_\{ij\} = \mathbf\{r\}_i - \mathbf\{r\}_j\) is the vector separating the two particle centers (note the i-j ordering so that \(F_\{ne\}\) is @@ -411,8 +411,8 @@ option by an additional factor of {a}, the radius of the contact region. The tan \mathbf\{F\}_t = -min(\mu_t F_\{n0\}, \|-k_t a \mathbf\{\xi\} + \mathbf\{F\}_\mathrm\{t,damp\}\|) \mathbf\{t\} \end\{equation\} -Here, {a} is the radius of the contact region, given by \(a = \delta -R\) for all normal contact models, except for {jkr}, where it is given +Here, {a} is the radius of the contact region, given by \(a =\sqrt\{R\delta\}\) + for all normal contact models, except for {jkr}, where it is given implicitly by \(\delta = a^2/R - 2\sqrt\{\pi \gamma a/E\}\), see discussion above. To match the Mindlin solution, one should set \(k_t = 8G\), where \(G\) is the shear modulus, related to Young's modulus @@ -680,7 +680,7 @@ The single() function of these pair styles returns 0.0 for the energy of a pairwise interaction, since energy is not conserved in these dissipative potentials. It also returns only the normal component of the pairwise interaction force. However, the single() function also -calculates 10 extra pairwise quantities. The first 3 are the +calculates 12 extra pairwise quantities. The first 3 are the components of the tangential force between particles I and J, acting on particle I. The 4th is the magnitude of this tangential force. The next 3 (5-7) are the components of the rolling torque acting on diff --git a/src/GRANULAR/pair_granular.cpp b/src/GRANULAR/pair_granular.cpp index 2813035ebb..334c6a471e 100644 --- a/src/GRANULAR/pair_granular.cpp +++ b/src/GRANULAR/pair_granular.cpp @@ -391,6 +391,7 @@ void PairGranular::compute(int eflag, int vflag) } else { Fncrit = fabs(Fntot); } + Fscrit = tangential_coeffs[itype][jtype][2] * Fncrit; //------------------------------ // tangential forces @@ -446,7 +447,6 @@ void PairGranular::compute(int eflag, int vflag) fs3 = -k_tangential*history[2] - damp_tangential*vtr3; // rescale frictional displacements and forces if needed - Fscrit = tangential_coeffs[itype][jtype][2] * Fncrit; fs = sqrt(fs1*fs1 + fs2*fs2 + fs3*fs3); if (fs > Fscrit) { shrmag = sqrt(history[0]*history[0] + history[1]*history[1] + @@ -464,8 +464,8 @@ void PairGranular::compute(int eflag, int vflag) } else fs1 = fs2 = fs3 = 0.0; } } else { // classic pair gran/hooke (no history) - fs = meff*damp_tangential*vrel; - if (vrel != 0.0) Ft = MIN(Fne,fs) / vrel; + fs = damp_tangential*vrel; // From documentation: F_{t,damp} = - \eta_t v_{t,rel}, no need for extra `meff` + if (vrel != 0.0) Ft = MIN(Fscrit,fs) / vrel; // From documentation: critical force `Fscrit` used, not elastic normal force `Fne` else Ft = 0.0; fs1 = -Ft*vtr1; fs2 = -Ft*vtr2; @@ -635,7 +635,7 @@ void PairGranular::compute(int eflag, int vflag) torque[j][2] -= torroll3; } } - if (evflag) ev_tally_xyz(i,j,nlocal,0, + if (evflag) ev_tally_xyz(i,j,nlocal,0,//Should `newton_pair` passed instead of 0 ? 0.0,0.0,fx,fy,fz,delx,dely,delz); } } @@ -1451,11 +1451,13 @@ double PairGranular::single(int i, int j, int itype, int jtype, } if (damping_model[itype][jtype] == VELOCITY) { - damp_normal = normal_coeffs[itype][jtype][1]; + damp_normal = 1; + } else if (damping_model[itype][jtype] == MASS_VELOCITY) { + damp_normal = meff; } else if (damping_model[itype][jtype] == VISCOELASTIC) { - damp_normal = normal_coeffs[itype][jtype][1]*a*meff; + damp_normal = a*meff; } else if (damping_model[itype][jtype] == TSUJI) { - damp_normal = normal_coeffs[itype][jtype][1]*sqrt(meff*knfac); + damp_normal = sqrt(meff*knfac); } damp_normal_prefactor = normal_coeffs[itype][jtype][1]*damp_normal; @@ -1473,6 +1475,7 @@ double PairGranular::single(int i, int j, int itype, int jtype, if (neighprev >= jnum) neighprev = 0; if (jlist[neighprev] == j) break; } + // the `history` pointer must not be modified here in single() function. already calculated in the compute() function. If modified here it changes the pair forces that have friction/twisting/rolling and history effects ! history = &allhistory[size_history*neighprev]; } @@ -1506,6 +1509,7 @@ double PairGranular::single(int i, int j, int itype, int jtype, } else { Fncrit = fabs(Fntot); } + Fscrit = tangential_coeffs[itype][jtype][2] * Fncrit; //------------------------------ // tangential forces @@ -1518,13 +1522,6 @@ double PairGranular::single(int i, int j, int itype, int jtype, k_tangential *= a; } else if (tangential_model[itype][jtype] == TANGENTIAL_MINDLIN_RESCALE) { k_tangential *= a; - // on unloading, rescale the shear displacements - if (a < history[3]) { - double factor = a/history[3]; - history[0] *= factor; - history[1] *= factor; - history[2] *= factor; - } } shrmag = sqrt(history[0]*history[0] + history[1]*history[1] + @@ -1535,28 +1532,26 @@ double PairGranular::single(int i, int j, int itype, int jtype, fs2 = -k_tangential*history[1] - damp_tangential*vtr2; fs3 = -k_tangential*history[2] - damp_tangential*vtr3; - // rescale frictional displacements and forces if needed - Fscrit = tangential_coeffs[itype][jtype][2] * Fncrit; + // rescale frictional forces if needed fs = sqrt(fs1*fs1 + fs2*fs2 + fs3*fs3); if (fs > Fscrit) { if (shrmag != 0.0) { - history[0] = -1.0/k_tangential*(Fscrit*fs1/fs + damp_tangential*vtr1); - history[1] = -1.0/k_tangential*(Fscrit*fs2/fs + damp_tangential*vtr2); - history[2] = -1.0/k_tangential*(Fscrit*fs3/fs + damp_tangential*vtr3); fs1 *= Fscrit/fs; fs2 *= Fscrit/fs; fs3 *= Fscrit/fs; - } else fs1 = fs2 = fs3 = 0.0; + fs *= Fscrit/fs; // saves the correct value of `fs` to svector + } else fs1 = fs2 = fs3 = fs = 0.0; // saves the correct of `fs` value to svector } // classic pair gran/hooke (no history) } else { - fs = meff*damp_tangential*vrel; - if (vrel != 0.0) Ft = MIN(Fne,fs) / vrel; + fs = damp_tangential*vrel; + if (vrel != 0.0) Ft = MIN(Fscrit,fs) / vrel; else Ft = 0.0; fs1 = -Ft*vtr1; fs2 = -Ft*vtr2; fs3 = -Ft*vtr3; + fs = Ft*vrel; // saves the correct value of `fs` to svector } //**************************************** @@ -1601,7 +1596,8 @@ double PairGranular::single(int i, int j, int itype, int jtype, fr1 *= Frcrit/fr; fr2 *= Frcrit/fr; fr3 *= Frcrit/fr; - } else fr1 = fr2 = fr3 = 0.0; + fr *= Frcrit/fr; // saves the correct value of `fr` to svector + } else fr1 = fr2 = fr3 = fr = 0.0; // saves the correct value of `fr` to svector } } From a5acf1655bd05de4d13921d25fb647f1d5d29ab3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 16 Aug 2019 17:30:37 -0400 Subject: [PATCH 095/557] resolve small formatting glitch Text blocks must all be flush on the left side or else sphinx gets confused since indenting is part of the syntax. --- doc/src/pair_granular.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/pair_granular.txt b/doc/src/pair_granular.txt index ccfe805b67..9fcc4dbe48 100644 --- a/doc/src/pair_granular.txt +++ b/doc/src/pair_granular.txt @@ -412,7 +412,7 @@ option by an additional factor of {a}, the radius of the contact region. The tan \end\{equation\} Here, {a} is the radius of the contact region, given by \(a =\sqrt\{R\delta\}\) - for all normal contact models, except for {jkr}, where it is given +for all normal contact models, except for {jkr}, where it is given implicitly by \(\delta = a^2/R - 2\sqrt\{\pi \gamma a/E\}\), see discussion above. To match the Mindlin solution, one should set \(k_t = 8G\), where \(G\) is the shear modulus, related to Young's modulus From c71e869a33cdec0c855763a0ce60928cf1149975 Mon Sep 17 00:00:00 2001 From: alxvov Date: Wed, 21 Aug 2019 14:02:34 +0000 Subject: [PATCH 096/557] define params in creator as init is called after modify --- src/SPIN/min_spin.cpp | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index c8e0020ef8..947e281b42 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -41,15 +41,15 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ -MinSpin::MinSpin(LAMMPS *lmp) : Min(lmp) {} +MinSpin::MinSpin(LAMMPS *lmp) : Min(lmp) { + alpha_damp = 1.0; + discrete_factor = 10.0; +} /* ---------------------------------------------------------------------- */ void MinSpin::init() { - alpha_damp = 1.0; - discrete_factor = 10.0; - Min::init(); dts = dt = update->dt; From 52a51ea470dbd9f844db003af0153e3dad33c493 Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Wed, 21 Aug 2019 19:14:08 -0700 Subject: [PATCH 097/557] Simplified GJF formalism --- src/fix_langevin.cpp | 762 ++++++++++++++++++------------------------- src/fix_langevin.h | 135 +++----- 2 files changed, 371 insertions(+), 526 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index d323453cdb..b8144fc5f3 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -2,20 +2,16 @@ 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: Carolyn Phillips (U Mich), reservoir energy tally Aidan Thompson (SNL) GJF formulation - Charles Sievers (UC Davis) GJF-2GJ Implementation - Niels Gronbech-Jensen (UC Davis) GJF-2GJ Formulation ------------------------------------------------------------------------- */ #include "fix_langevin.h" @@ -50,10 +46,9 @@ enum{CONSTANT,EQUAL,ATOM}; /* ---------------------------------------------------------------------- */ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : - Fix(lmp, narg, arg), - gjfflag(0), gfactor1(NULL), gfactor2(NULL), ratio(NULL), tstr(NULL), - flangevin(NULL), tforce(NULL), franprev(NULL), id_temp(NULL), random(NULL), - lv(NULL), wildcard(NULL), bias(NULL) + Fix(lmp, narg, arg), + gjfflag(0), gfactor1(NULL), gfactor2(NULL), ratio(NULL), tstr(NULL), + flangevin(NULL), tforce(NULL), franprev(NULL), id_temp(NULL), random(NULL), lv(NULL) { if (narg < 7) error->all(FLERR,"Illegal fix langevin command"); @@ -98,7 +93,6 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : oflag = 0; tallyflag = 0; zeroflag = 0; - hsflag = 0; int iarg = 7; while (iarg < narg) { @@ -110,10 +104,7 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : } else if (strcmp(arg[iarg],"gjf") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); if (strcmp(arg[iarg+1],"no") == 0) gjfflag = 0; - else if (strcmp(arg[iarg+1],"yes") == 0) - error->all(FLERR,"GJF yes keyword is deprecated.\nPlease use vhalf or vfull."); - else if (strcmp(arg[iarg+1],"vfull") == 0) {gjfflag = 1; hsflag = 0;} - else if (strcmp(arg[iarg+1],"vhalf") == 0) {gjfflag = 1; hsflag = 1;} + else if (strcmp(arg[iarg+1],"yes") == 0) gjfflag = 1; else error->all(FLERR,"Illegal fix langevin command"); iarg += 2; } else if (strcmp(arg[iarg],"omega") == 0) { @@ -159,9 +150,7 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : flangevin = NULL; flangevin_allocated = 0; franprev = NULL; - wildcard = NULL; lv = NULL; - bias = NULL; tforce = NULL; maxatom1 = maxatom2 = 0; @@ -170,26 +159,19 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : // no need to set peratom_flag, b/c data is for internal use only if (gjfflag) { - - nvalues = 3; grow_arrays(atom->nmax); atom->add_callback(0); - // initialize franprev to zero + // initialize franprev to zero int nlocal = atom->nlocal; for (int i = 0; i < nlocal; i++) { franprev[i][0] = 0.0; franprev[i][1] = 0.0; franprev[i][2] = 0.0; - wildcard[i][0] = 0.0; - wildcard[i][1] = 0.0; - wildcard[i][2] = 0.0; - if (hsflag) { - lv[i][0] = 0.0; - lv[i][1] = 0.0; - lv[i][2] = 0.0; - } + lv[i][0] = 0.0; + lv[i][1] = 0.0; + lv[i][2] = 0.0; } } @@ -210,9 +192,7 @@ FixLangevin::~FixLangevin() if (gjfflag) { memory->destroy(franprev); - memory->destroy(wildcard); - if (hsflag) memory->destroy(lv); - if (temperature && temperature->tempbias) memory->destroy(bias); + memory->destroy(lv); atom->delete_callback(id,0); } } @@ -222,7 +202,8 @@ FixLangevin::~FixLangevin() int FixLangevin::setmask() { int mask = 0; - if (gjfflag) mask |= POST_INTEGRATE; + if (gjfflag) mask |= INITIAL_INTEGRATE; + if (gjfflag) mask |= INITIAL_INTEGRATE_RESPA; mask |= POST_FORCE; mask |= POST_FORCE_RESPA; mask |= END_OF_STEP; @@ -234,14 +215,26 @@ int FixLangevin::setmask() void FixLangevin::init() { + if (gjfflag){ + if (t_period*2 == update->dt) + error->all(FLERR,"Fix langevin gjf cannot have t_period equal to dt/2 at the start"); + + // warn if any integrate fix comes after this one + int before = 1; + int flag = 0; + for (int i = 0; i < modify->nfix; i++) { + if (strcmp(id,modify->fix[i]->id) == 0) before = 0; + else if ((modify->fmask[i] && strcmp(modify->fix[i]->style,"nve")==0) && before) flag = 1; + } + if (flag && comm->me == 0) + error->all(FLERR,"Fix langevin gjf should come before fix nve"); + } + if (oflag && !atom->sphere_flag) error->all(FLERR,"Fix langevin omega requires atom style sphere"); if (ascale && !atom->ellipsoid_flag) error->all(FLERR,"Fix langevin angmom requires atom style ellipsoid"); - if (gjfflag && zeroflag && tallyflag) - error->warning(FLERR, - "Fix langevin: gjf, zero, and tally were all set correct energy tallying is not guaranteed"); // check variable if (tstr) { @@ -281,17 +274,19 @@ void FixLangevin::init() error->one(FLERR,"Fix langevin angmom requires extended particles"); } + // set force prefactors + if (!atom->rmass) { for (int i = 1; i <= atom->ntypes; i++) { gfactor1[i] = -atom->mass[i] / t_period / force->ftm2v; - if (gjfflag) + if (!gjfflag) gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / - force->ftm2v; + sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / + force->ftm2v; else gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / - force->ftm2v; + sqrt(2.0*force->boltz/t_period/update->dt/force->mvv2e) / + force->ftm2v; gfactor1[i] *= 1.0/ratio[i]; gfactor2[i] *= 1.0/sqrt(ratio[i]); } @@ -303,17 +298,57 @@ void FixLangevin::init() if (strstr(update->integrate_style,"respa")) nlevels_respa = ((Respa *) update->integrate)->nlevels; - if (strstr(update->integrate_style,"respa")) - error->one(FLERR,"Fix langevin gjf not implemented with respa capabilities"); - - if (gjfflag) gjffac = 1.0/sqrt(1.0+update->dt/2.0/t_period); - + if (gjfflag) gjfa = (1.0-update->dt/2.0/t_period)/(1.0+update->dt/2.0/t_period); + if (gjfflag) gjfsib = sqrt(1.0+update->dt/2.0/t_period); } /* ---------------------------------------------------------------------- */ void FixLangevin::setup(int vflag) { + if (gjfflag){ + double dtfm; + double dt = update->dt; + double **v = atom->v; + double **f = atom->f; + int *mask = atom->mask; + int nlocal = atom->nlocal; + double *rmass = atom->rmass; + double *mass = atom->mass; + int *type = atom->type; + if (rmass) { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = 0.5 * dt / rmass[i]; + v[i][0] -= dtfm * f[i][0]; + v[i][1] -= dtfm * f[i][1]; + v[i][2] -= dtfm * f[i][2]; + if (tbiasflag) + temperature->remove_bias(i,v[i]); + v[i][0] /= gjfa*gjfsib*gjfsib; + v[i][1] /= gjfa*gjfsib*gjfsib; + v[i][2] /= gjfa*gjfsib*gjfsib; + if (tbiasflag) + temperature->restore_bias(i,v[i]); + } + + } else { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = 0.5 * dt / mass[type[i]]; + v[i][0] -= dtfm * f[i][0]; + v[i][1] -= dtfm * f[i][1]; + v[i][2] -= dtfm * f[i][2]; + if (tbiasflag) + temperature->remove_bias(i,v[i]); + v[i][0] /= gjfa*gjfsib*gjfsib; + v[i][1] /= gjfa*gjfsib*gjfsib; + v[i][2] /= gjfa*gjfsib*gjfsib; + if (tbiasflag) + temperature->restore_bias(i,v[i]); + } + } + } if (strstr(update->integrate_style,"verlet")) post_force(vflag); else { @@ -321,144 +356,67 @@ void FixLangevin::setup(int vflag) post_force_respa(vflag,nlevels_respa-1,0); ((Respa *) update->integrate)->copy_f_flevel(nlevels_respa-1); } - if (gjfflag) { - - // update v of atoms in group - double ** v = atom->v; + if (gjfflag){ + double dtfm; + double dt = update->dt; double **f = atom->f; + double **v = atom->v; + int *mask = atom->mask; int nlocal = atom->nlocal; - if (igroup == atom->firstgroup) nlocal = atom->nfirst; - double b[3] = {0.0,0.0,0.0}; - - for (int i = 0; i < nlocal; i++) { - f[i][0] = wildcard[i][0]; - f[i][1] = wildcard[i][1]; - f[i][2] = wildcard[i][2]; - b[0] = v[i][0]; - b[1] = v[i][1]; - b[2] = v[i][2]; - if (tbiasflag == BIAS) temperature->remove_bias(i,v[i]); - wildcard[i][0] = v[i][0]; - wildcard[i][1] = v[i][1]; - wildcard[i][2] = v[i][2]; - if (tbiasflag == BIAS) { - temperature->restore_bias(i,v[i]); - bias[i][0] = b[0] - wildcard[i][0]; - bias[i][1] = b[1] - wildcard[i][1]; - bias[i][2] = b[2] - wildcard[i][2]; - } + double *rmass = atom->rmass; + double *mass = atom->mass; + int *type = atom->type; + if (rmass) { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = 0.5 * dt / rmass[i]; + v[i][0] += dtfm * f[i][0]; + v[i][1] += dtfm * f[i][1]; + v[i][2] += dtfm * f[i][2]; + lv[i][0] = f[i][0]; + lv[i][1] = f[i][1]; + lv[i][2] = f[i][2]; + } +// + } else { + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) { + dtfm = 0.5 * dt / mass[type[i]]; + v[i][0] += dtfm * f[i][0]; + v[i][1] += dtfm * f[i][1]; + v[i][2] += dtfm * f[i][2]; + lv[i][0] = v[i][0]; + lv[i][1] = v[i][1]; + lv[i][2] = v[i][2]; + } } } } -/* ---------------------------------------------------------------------- - allow for both per-type and per-atom mass -------------------------------------------------------------------------- */ +/* ---------------------------------------------------------------------- */ -void FixLangevin::post_integrate() +void FixLangevin::initial_integrate_respa(int vflag, int ilevel, int /* iloop */){ + if (ilevel == respa_level-1) initial_integrate(vflag); +} + +/* ---------------------------------------------------------------------- */ + +void FixLangevin::initial_integrate(int /* vflag */) { - double dtfm; - double dt = update->dt; - double dtf = 0.5 * dt * force->ftm2v; - - // update v of atoms in group - - double **x = atom->x; double **v = atom->v; double **f = atom->f; - double *rmass = atom->rmass; - double *mass = atom->mass; - int *type = atom->type; int *mask = atom->mask; int nlocal = atom->nlocal; - if (igroup == atom->firstgroup) nlocal = atom->nfirst; - // zero option - double vsum[3],vsumall[3]; - bigint count; - - if (zeroflag) { - vsum[0] = vsum[1] = vsum[2] = 0.0; - count = group->count(igroup); - if (count == 0) - error->all(FLERR,"Cannot zero Langevin force of 0 atoms"); - } - - if (rmass) { - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) { - dtfm = dtf / rmass[i]; - x[i][0] -= dt * v[i][0]; - x[i][1] -= dt * v[i][1]; - x[i][2] -= dt * v[i][2]; - v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); - v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); - v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); - if (tbiasflag == BIAS) - for (int j = 0; j < 3; j++) { - if (wildcard[i][j] == 0) { - v[i][j] /= gjffac * gjffac; - } - } - x[i][0] += gjffac * dt * v[i][0]; - x[i][1] += gjffac * dt * v[i][1]; - x[i][2] += gjffac * dt * v[i][2]; - if (tbiasflag == BIAS) - for (int j = 0; j < 3; j++) { - if (wildcard[i][j] == 0) - v[i][j] *= gjffac; - v[i][j] += bias[i][j]; - x[i][j] += dt * bias[i][j]; - } - } - - } else { - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) { - dtfm = dtf / mass[type[i]]; - x[i][0] -= dt * v[i][0]; - x[i][1] -= dt * v[i][1]; - x[i][2] -= dt * v[i][2]; - v[i][0] = gjffac * (wildcard[i][0] + dtfm * franprev[i][0] + dtfm * f[i][0]); - v[i][1] = gjffac * (wildcard[i][1] + dtfm * franprev[i][1] + dtfm * f[i][1]); - v[i][2] = gjffac * (wildcard[i][2] + dtfm * franprev[i][2] + dtfm * f[i][2]); - if (tbiasflag == BIAS) - for (int j = 0; j < 3; j++) { - if (wildcard[i][j] == 0) { - v[i][j] /= gjffac*gjffac; - } - } - x[i][0] += gjffac * dt * v[i][0]; - x[i][1] += gjffac * dt * v[i][1]; - x[i][2] += gjffac * dt * v[i][2]; - if (tbiasflag == BIAS) - for (int j = 0; j < 3; j++) { - if (wildcard[i][j] == 0) - v[i][j] *= gjffac; - v[i][j] += bias[i][j]; - x[i][j] += dt * bias[i][j]; - } - if (zeroflag){ - vsum[0] += gjffac * dtfm * franprev[i][0]; - vsum[1] += gjffac * dtfm * franprev[i][1]; - vsum[2] += gjffac * dtfm * franprev[i][2]; - } - } - } - - if (zeroflag) { - MPI_Allreduce(vsum,vsumall,3,MPI_DOUBLE,MPI_SUM,world); - vsumall[0] /= count; - vsumall[1] /= count; - vsumall[2] /= count; - for (int i = 0; i < nlocal; i++) { - if (mask[i] & groupbit) { - v[i][0] -= vsumall[0]; - v[i][1] -= vsumall[1]; - v[i][2] -= vsumall[2]; - } + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit){ + f[i][0] /= gjfa; + f[i][1] /= gjfa; + f[i][2] /= gjfa; + v[i][0] = lv[i][0]; + v[i][1] = lv[i][1]; + v[i][2] = lv[i][2]; } - } } /* ---------------------------------------------------------------------- */ @@ -479,124 +437,124 @@ void FixLangevin::post_force(int /*vflag*/) if (zeroflag) post_force_templated<1,1,1,1,1,1>(); else post_force_templated<1,1,1,1,1,0>(); else - if (zeroflag) post_force_templated<1,1,1,1,0,1>(); - else post_force_templated<1,1,1,1,0,0>(); + if (zeroflag) post_force_templated<1,1,1,1,0,1>(); + else post_force_templated<1,1,1,1,0,0>(); else - if (rmass) - if (zeroflag) post_force_templated<1,1,1,0,1,1>(); - else post_force_templated<1,1,1,0,1,0>(); - else - if (zeroflag) post_force_templated<1,1,1,0,0,1>(); - else post_force_templated<1,1,1,0,0,0>(); + if (rmass) + if (zeroflag) post_force_templated<1,1,1,0,1,1>(); + else post_force_templated<1,1,1,0,1,0>(); + else + if (zeroflag) post_force_templated<1,1,1,0,0,1>(); + else post_force_templated<1,1,1,0,0,0>(); else - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<1,1,0,1,1,1>(); - else post_force_templated<1,1,0,1,1,0>(); - else - if (zeroflag) post_force_templated<1,1,0,1,0,1>(); - else post_force_templated<1,1,0,1,0,0>(); + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<1,1,0,1,1,1>(); + else post_force_templated<1,1,0,1,1,0>(); else - if (rmass) - if (zeroflag) post_force_templated<1,1,0,0,1,1>(); - else post_force_templated<1,1,0,0,1,0>(); - else - if (zeroflag) post_force_templated<1,1,0,0,0,1>(); - else post_force_templated<1,1,0,0,0,0>(); + if (zeroflag) post_force_templated<1,1,0,1,0,1>(); + else post_force_templated<1,1,0,1,0,0>(); + else + if (rmass) + if (zeroflag) post_force_templated<1,1,0,0,1,1>(); + else post_force_templated<1,1,0,0,1,0>(); + else + if (zeroflag) post_force_templated<1,1,0,0,0,1>(); + else post_force_templated<1,1,0,0,0,0>(); else - if (tallyflag) - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<1,0,1,1,1,1>(); - else post_force_templated<1,0,1,1,1,0>(); - else - if (zeroflag) post_force_templated<1,0,1,1,0,1>(); - else post_force_templated<1,0,1,1,0,0>(); + if (tallyflag) + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<1,0,1,1,1,1>(); + else post_force_templated<1,0,1,1,1,0>(); else - if (rmass) - if (zeroflag) post_force_templated<1,0,1,0,1,1>(); - else post_force_templated<1,0,1,0,1,0>(); - else - if (zeroflag) post_force_templated<1,0,1,0,0,1>(); - else post_force_templated<1,0,1,0,0,0>(); + if (zeroflag) post_force_templated<1,0,1,1,0,1>(); + else post_force_templated<1,0,1,1,0,0>(); else - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<1,0,0,1,1,1>(); - else post_force_templated<1,0,0,1,1,0>(); - else - if (zeroflag) post_force_templated<1,0,0,1,0,1>(); - else post_force_templated<1,0,0,1,0,0>(); - else - if (rmass) - if (zeroflag) post_force_templated<1,0,0,0,1,1>(); - else post_force_templated<1,0,0,0,1,0>(); - else - if (zeroflag) post_force_templated<1,0,0,0,0,1>(); - else post_force_templated<1,0,0,0,0,0>(); + if (rmass) + if (zeroflag) post_force_templated<1,0,1,0,1,1>(); + else post_force_templated<1,0,1,0,1,0>(); + else + if (zeroflag) post_force_templated<1,0,1,0,0,1>(); + else post_force_templated<1,0,1,0,0,0>(); + else + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<1,0,0,1,1,1>(); + else post_force_templated<1,0,0,1,1,0>(); + else + if (zeroflag) post_force_templated<1,0,0,1,0,1>(); + else post_force_templated<1,0,0,1,0,0>(); + else + if (rmass) + if (zeroflag) post_force_templated<1,0,0,0,1,1>(); + else post_force_templated<1,0,0,0,1,0>(); + else + if (zeroflag) post_force_templated<1,0,0,0,0,1>(); + else post_force_templated<1,0,0,0,0,0>(); else - if (gjfflag) - if (tallyflag) - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<0,1,1,1,1,1>(); - else post_force_templated<0,1,1,1,1,0>(); - else - if (zeroflag) post_force_templated<0,1,1,1,0,1>(); - else post_force_templated<0,1,1,1,0,0>(); + if (gjfflag) + if (tallyflag) + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<0,1,1,1,1,1>(); + else post_force_templated<0,1,1,1,1,0>(); else - if (rmass) - if (zeroflag) post_force_templated<0,1,1,0,1,1>(); - else post_force_templated<0,1,1,0,1,0>(); - else - if (zeroflag) post_force_templated<0,1,1,0,0,1>(); - else post_force_templated<0,1,1,0,0,0>(); + if (zeroflag) post_force_templated<0,1,1,1,0,1>(); + else post_force_templated<0,1,1,1,0,0>(); else - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<0,1,0,1,1,1>(); - else post_force_templated<0,1,0,1,1,0>(); - else - if (zeroflag) post_force_templated<0,1,0,1,0,1>(); - else post_force_templated<0,1,0,1,0,0>(); - else - if (rmass) - if (zeroflag) post_force_templated<0,1,0,0,1,1>(); - else post_force_templated<0,1,0,0,1,0>(); - else - if (zeroflag) post_force_templated<0,1,0,0,0,1>(); - else post_force_templated<0,1,0,0,0,0>(); + if (rmass) + if (zeroflag) post_force_templated<0,1,1,0,1,1>(); + else post_force_templated<0,1,1,0,1,0>(); + else + if (zeroflag) post_force_templated<0,1,1,0,0,1>(); + else post_force_templated<0,1,1,0,0,0>(); else - if (tallyflag) - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<0,0,1,1,1,1>(); - else post_force_templated<0,0,1,1,1,0>(); - else - if (zeroflag) post_force_templated<0,0,1,1,0,1>(); - else post_force_templated<0,0,1,1,0,0>(); - else - if (rmass) - if (zeroflag) post_force_templated<0,0,1,0,1,1>(); - else post_force_templated<0,0,1,0,1,0>(); - else - if (zeroflag) post_force_templated<0,0,1,0,0,1>(); - else post_force_templated<0,0,1,0,0,0>(); + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<0,1,0,1,1,1>(); + else post_force_templated<0,1,0,1,1,0>(); else - if (tbiasflag == BIAS) - if (rmass) - if (zeroflag) post_force_templated<0,0,0,1,1,1>(); - else post_force_templated<0,0,0,1,1,0>(); - else - if (zeroflag) post_force_templated<0,0,0,1,0,1>(); - else post_force_templated<0,0,0,1,0,0>(); - else - if (rmass) - if (zeroflag) post_force_templated<0,0,0,0,1,1>(); - else post_force_templated<0,0,0,0,1,0>(); - else - if (zeroflag) post_force_templated<0,0,0,0,0,1>(); - else post_force_templated<0,0,0,0,0,0>(); + if (zeroflag) post_force_templated<0,1,0,1,0,1>(); + else post_force_templated<0,1,0,1,0,0>(); + else + if (rmass) + if (zeroflag) post_force_templated<0,1,0,0,1,1>(); + else post_force_templated<0,1,0,0,1,0>(); + else + if (zeroflag) post_force_templated<0,1,0,0,0,1>(); + else post_force_templated<0,1,0,0,0,0>(); + else + if (tallyflag) + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<0,0,1,1,1,1>(); + else post_force_templated<0,0,1,1,1,0>(); + else + if (zeroflag) post_force_templated<0,0,1,1,0,1>(); + else post_force_templated<0,0,1,1,0,0>(); + else + if (rmass) + if (zeroflag) post_force_templated<0,0,1,0,1,1>(); + else post_force_templated<0,0,1,0,1,0>(); + else + if (zeroflag) post_force_templated<0,0,1,0,0,1>(); + else post_force_templated<0,0,1,0,0,0>(); + else + if (tbiasflag == BIAS) + if (rmass) + if (zeroflag) post_force_templated<0,0,0,1,1,1>(); + else post_force_templated<0,0,0,1,1,0>(); + else + if (zeroflag) post_force_templated<0,0,0,1,0,1>(); + else post_force_templated<0,0,0,1,0,0>(); + else + if (rmass) + if (zeroflag) post_force_templated<0,0,0,0,1,1>(); + else post_force_templated<0,0,0,0,1,0>(); + else + if (zeroflag) post_force_templated<0,0,0,0,0,1>(); + else post_force_templated<0,0,0,0,0,0>(); } /* ---------------------------------------------------------------------- */ @@ -611,7 +569,7 @@ void FixLangevin::post_force_respa(int vflag, int ilevel, int /*iloop*/) ------------------------------------------------------------------------- */ template < int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, - int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > + int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > void FixLangevin::post_force_templated() { double gamma1,gamma2; @@ -644,8 +602,9 @@ void FixLangevin::post_force_templated() // sum random force over all atoms in group // subtract sum/count from each atom in group - double fdrag[3],fran[3],fsum[3],fsumall[3], rantemp[3]; + double fdrag[3],fran[3],fsum[3],fsumall[3]; bigint count; + double fswap; double boltz = force->boltz; double dt = update->dt; @@ -672,33 +631,33 @@ void FixLangevin::post_force_templated() flangevin_allocated = 1; } - if (Tp_BIAS && !gjfflag) temperature->compute_scalar(); - else if (Tp_BIAS && update->ntimestep == update->beginstep && gjfflag) temperature->compute_scalar(); + if (Tp_BIAS) temperature->compute_scalar(); for (int i = 0; i < nlocal; i++) { if (mask[i] & groupbit) { if (Tp_TSTYLEATOM) tsqrt = sqrt(tforce[i]); if (Tp_RMASS) { gamma1 = -rmass[i] / t_period / ftm2v; - if (Tp_GJF) - gamma2 = sqrt(rmass[i]) * sqrt(2.0 * boltz / t_period / dt / mvv2e) / ftm2v; + if (!Tp_GJF) + gamma2 = sqrt(rmass[i]) * sqrt(24.0*boltz/t_period/dt/mvv2e) / ftm2v; else - gamma2 = sqrt(rmass[i]) * sqrt(24.0 * boltz / t_period / dt / mvv2e) / ftm2v; - gamma1 *= 1.0 / ratio[type[i]]; - gamma2 *= 1.0 / sqrt(ratio[type[i]]) * tsqrt; + gamma2 = sqrt(rmass[i]) * sqrt(2.0*boltz/t_period/dt/mvv2e) / ftm2v; + gamma1 *= 1.0/ratio[type[i]]; + gamma2 *= 1.0/sqrt(ratio[type[i]]) * tsqrt; } else { gamma1 = gfactor1[type[i]]; gamma2 = gfactor2[type[i]] * tsqrt; } - if (Tp_GJF) { - fran[0] = gamma2 * random->gaussian(); - fran[1] = gamma2 * random->gaussian(); - fran[2] = gamma2 * random->gaussian(); - } else { - fran[0] = gamma2 * (random->uniform()-0.5); - fran[1] = gamma2 * (random->uniform()-0.5); - fran[2] = gamma2 * (random->uniform()-0.5); + if (!Tp_GJF){ + fran[0] = gamma2*(random->uniform()-0.5); + fran[1] = gamma2*(random->uniform()-0.5); + fran[2] = gamma2*(random->uniform()-0.5); + } + else{ + fran[0] = gamma2*random->gaussian(); + fran[1] = gamma2*random->gaussian(); + fran[2] = gamma2*random->gaussian(); } if (Tp_BIAS) { @@ -717,21 +676,35 @@ void FixLangevin::post_force_templated() } if (Tp_GJF) { - wildcard[i][0] = f[i][0]; - wildcard[i][1] = f[i][1]; - wildcard[i][2] = f[i][2]; + if (Tp_BIAS) + temperature->remove_bias(i,v[i]); + lv[i][0] = gjfsib*v[i][0]; + lv[i][1] = gjfsib*v[i][1]; + lv[i][2] = gjfsib*v[i][2]; + if (Tp_BIAS) + temperature->restore_bias(i,v[i]); + if (Tp_BIAS) + temperature->restore_bias(i,lv[i]); - rantemp[0] = fran[0]; - rantemp[1] = fran[1]; - rantemp[2] = fran[2]; + fswap = 0.5*(fran[0]+franprev[i][0]); + franprev[i][0] = fran[0]; + fran[0] = fswap; + fswap = 0.5*(fran[1]+franprev[i][1]); + franprev[i][1] = fran[1]; + fran[1] = fswap; + fswap = 0.5*(fran[2]+franprev[i][2]); + franprev[i][2] = fran[2]; + fran[2] = fswap; - fran[0] = franprev[i][0]; - fran[1] = franprev[i][1]; - fran[2] = franprev[i][2]; - - fdrag[0] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; - fdrag[1] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; - fdrag[2] *= -2*t_period*((2*gjffac)-(1.0/gjffac)-1.0)/dt; + fdrag[0] *= gjfa; + fdrag[1] *= gjfa; + fdrag[2] *= gjfa; + fran[0] *= gjfa; + fran[1] *= gjfa; + fran[2] *= gjfa; + f[i][0] *= gjfa; + f[i][1] *= gjfa; + f[i][2] *= gjfa; } f[i][0] += fdrag[0] + fran[0]; @@ -739,61 +712,15 @@ void FixLangevin::post_force_templated() f[i][2] += fdrag[2] + fran[2]; if (Tp_TALLY) { - if (Tp_GJF && update->ntimestep != update->beginstep){ - if (Tp_BIAS) { - temperature->remove_bias(i,v[i]); - fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; - fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; - fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; - temperature->restore_bias(i,v[i]); - } else { - fdrag[0] = gamma1*gjffac*gjffac*v[i][0]; - fdrag[1] = gamma1*gjffac*gjffac*v[i][1]; - fdrag[2] = gamma1*gjffac*gjffac*v[i][2]; - } - fran[0] *= gjffac; - fran[1] *= gjffac; - fran[2] *= gjffac; - } - else if (Tp_GJF && update->ntimestep == update->beginstep){ - fdrag[0] = 0.0; - fdrag[1] = 0.0; - fdrag[2] = 0.0; - } flangevin[i][0] = fdrag[0] + fran[0]; flangevin[i][1] = fdrag[1] + fran[1]; flangevin[i][2] = fdrag[2] + fran[2]; } if (Tp_ZERO) { - if (!Tp_GJF){ - fsum[0] += fran[0]; - fsum[1] += fran[1]; - fsum[2] += fran[2]; - } - else { - fsum[0] += franprev[i][0]; - fsum[1] += franprev[i][1]; - fsum[2] += franprev[i][2]; - } - } - - if (Tp_GJF) - { - franprev[i][0] = rantemp[0]; - franprev[i][1] = rantemp[1]; - franprev[i][2] = rantemp[2]; - - if (hsflag){ - lv[i][0] = v[i][0]; - lv[i][1] = v[i][1]; - lv[i][2] = v[i][2]; - if (tbiasflag == BIAS) { - lv[i][0] += bias[i][0]; - lv[i][1] += bias[i][1]; - lv[i][2] += bias[i][2]; - } - } + fsum[0] += fran[0]; + fsum[1] += fran[1]; + fsum[2] += fran[2]; } } } @@ -977,46 +904,34 @@ void FixLangevin::end_of_step() if (!tallyflag && !gjfflag) return; double **v = atom->v; - double **f = atom->f; int *mask = atom->mask; int nlocal = atom->nlocal; - double b[3] = {0.0,0.0,0.0}; - - if (gjfflag && tbiasflag == BIAS) temperature->compute_scalar(); energy_onestep = 0.0; - for (int i = 0; i < nlocal; i++) - if (mask[i] & groupbit) { - if (gjfflag){ - b[0] = v[i][0]; - b[1] = v[i][1]; - b[2] = v[i][2]; - f[i][0] = wildcard[i][0]; - f[i][1] = wildcard[i][1]; - f[i][2] = wildcard[i][2]; - if (tbiasflag == BIAS) temperature->remove_bias(i,v[i]); - wildcard[i][0] = v[i][0]; - wildcard[i][1] = v[i][1]; - wildcard[i][2] = v[i][2]; - if (tbiasflag == BIAS) { - bias[i][0] = b[0] - v[i][0]; - bias[i][1] = b[1] - v[i][1]; - bias[i][2] = b[2] - v[i][2]; - temperature->restore_bias(i, v[i]); - } - if (hsflag){ - v[i][0] = lv[i][0]; - v[i][1] = lv[i][1]; - v[i][2] = lv[i][2]; - } + + if (gjfflag){ + double tmp[3]; + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit){ + tmp[0] = v[i][0]; + tmp[1] = v[i][1]; + tmp[2] = v[i][2]; + v[i][0] = lv[i][0]; + v[i][1] = lv[i][1]; + v[i][2] = lv[i][2]; + lv[i][0] = tmp[0]; + lv[i][1] = tmp[1]; + lv[i][2] = tmp[2]; } - if (tallyflag) - energy_onestep += flangevin[i][0] * v[i][0] + flangevin[i][1] * v[i][1] + - flangevin[i][2] * v[i][2]; - } - if (tallyflag) { - energy += energy_onestep * update->dt; } + + if (tallyflag) + for (int i = 0; i < nlocal; i++) + if (mask[i] & groupbit) + energy_onestep += flangevin[i][0]*v[i][0] + flangevin[i][1]*v[i][1] + + flangevin[i][2]*v[i][2]; + + energy += energy_onestep*update->dt; } /* ---------------------------------------------------------------------- */ @@ -1033,8 +948,8 @@ void FixLangevin::reset_dt() if (atom->mass) { for (int i = 1; i <= atom->ntypes; i++) { gfactor2[i] = sqrt(atom->mass[i]) * - sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / - force->ftm2v; + sqrt(24.0*force->boltz/t_period/update->dt/force->mvv2e) / + force->ftm2v; gfactor2[i] *= 1.0/sqrt(ratio[i]); } } @@ -1070,7 +985,7 @@ int FixLangevin::modify_param(int narg, char **arg) double FixLangevin::compute_scalar() { - if (!tallyflag && !flangevin_allocated) return 0.0; + if (!tallyflag || !flangevin_allocated) return 0.0; // capture the very first energy transfer to thermal reservoir @@ -1083,16 +998,13 @@ double FixLangevin::compute_scalar() for (int i = 0; i < nlocal; i++) if (mask[i] & groupbit) energy_onestep += flangevin[i][0]*v[i][0] + flangevin[i][1]*v[i][1] + - flangevin[i][2]*v[i][2]; + flangevin[i][2]*v[i][2]; energy = 0.5*energy_onestep*update->dt; } // convert midstep energy back to previous fullstep energy - double energy_me; - if (gjfflag) - energy_me = energy - energy_onestep*update->dt; - else - energy_me = energy - 0.5*energy_onestep*update->dt; + + double energy_me = energy - 0.5*energy_onestep*update->dt; double energy_all; MPI_Allreduce(&energy_me,&energy_all,1,MPI_DOUBLE,MPI_SUM,world); @@ -1119,9 +1031,7 @@ void *FixLangevin::extract(const char *str, int &dim) double FixLangevin::memory_usage() { double bytes = 0.0; - if (gjfflag) bytes += atom->nmax*3*2 * sizeof(double); - if (gjfflag) if (hsflag) bytes += atom->nmax*3 * sizeof(double); - if (gjfflag && tbiasflag == BIAS) bytes += atom->nmax*3 * sizeof(double); + if (gjfflag) bytes += atom->nmax*6 * sizeof(double); if (tallyflag) bytes += atom->nmax*3 * sizeof(double); if (tforce) bytes += atom->nmax * sizeof(double); return bytes; @@ -1134,9 +1044,7 @@ double FixLangevin::memory_usage() void FixLangevin::grow_arrays(int nmax) { memory->grow(franprev,nmax,3,"fix_langevin:franprev"); - memory->grow(wildcard,nmax,3,"fix_langevin:wildcard"); - if (hsflag) memory->grow(lv,nmax,3,"fix_langevin:lv"); - if (tbiasflag == BIAS) memory->grow(bias,nmax,3,"fix_langevin:bias"); + memory->grow(lv,nmax,3,"fix_langevin:lv"); } /* ---------------------------------------------------------------------- @@ -1148,19 +1056,9 @@ void FixLangevin::copy_arrays(int i, int j, int /*delflag*/) franprev[j][0] = franprev[i][0]; franprev[j][1] = franprev[i][1]; franprev[j][2] = franprev[i][2]; - wildcard[j][0] = wildcard[i][0]; - wildcard[j][1] = wildcard[i][1]; - wildcard[j][2] = wildcard[i][2]; - if (hsflag) { - lv[j][0] = lv[i][0]; - lv[j][1] = lv[i][1]; - lv[j][2] = lv[i][2]; - } - if (tbiasflag == BIAS){ - bias[j][0] = bias[i][0]; - bias[j][1] = bias[i][1]; - bias[j][2] = bias[i][2]; - } + lv[j][0] = lv[i][0]; + lv[j][1] = lv[i][1]; + lv[j][2] = lv[i][2]; } /* ---------------------------------------------------------------------- @@ -1173,19 +1071,9 @@ int FixLangevin::pack_exchange(int i, double *buf) buf[n++] = franprev[i][0]; buf[n++] = franprev[i][1]; buf[n++] = franprev[i][2]; - buf[n++] = wildcard[i][0]; - buf[n++] = wildcard[i][1]; - buf[n++] = wildcard[i][2]; - if (hsflag){ - buf[n++] = lv[i][0]; - buf[n++] = lv[i][1]; - buf[n++] = lv[i][2]; - } - if (tbiasflag == BIAS){ - buf[n++] = bias[i][0]; - buf[n++] = bias[i][1]; - buf[n++] = bias[i][2]; - } + buf[n++] = lv[i][0]; + buf[n++] = lv[i][1]; + buf[n++] = lv[i][2]; return n; } @@ -1199,18 +1087,8 @@ int FixLangevin::unpack_exchange(int nlocal, double *buf) franprev[nlocal][0] = buf[n++]; franprev[nlocal][1] = buf[n++]; franprev[nlocal][2] = buf[n++]; - wildcard[nlocal][0] = buf[n++]; - wildcard[nlocal][1] = buf[n++]; - wildcard[nlocal][2] = buf[n++]; - if (hsflag){ - lv[nlocal][0] = buf[n++]; - lv[nlocal][1] = buf[n++]; - lv[nlocal][2] = buf[n++]; - } - if (tbiasflag == BIAS){ - bias[nlocal][0] = buf[n++]; - bias[nlocal][1] = buf[n++]; - bias[nlocal][2] = buf[n++]; - } + lv[nlocal][0] = buf[n++]; + lv[nlocal][1] = buf[n++]; + lv[nlocal][2] = buf[n++]; return n; -} +} \ No newline at end of file diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 939b161c35..8b8c1cd6c8 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -2,12 +2,10 @@ 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. ------------------------------------------------------------------------- */ @@ -24,68 +22,64 @@ FixStyle(langevin,FixLangevin) namespace LAMMPS_NS { -class FixLangevin : public Fix { - public: - FixLangevin(class LAMMPS *, int, char **); - virtual ~FixLangevin(); - int setmask(); - void init(); - void setup(int); - //virtual void initial_integrate(int); - virtual void post_integrate(); - virtual void post_force(int); - void post_force_respa(int, int, int); - virtual void end_of_step(); - void reset_target(double); - void reset_dt(); - int modify_param(int, char **); - virtual double compute_scalar(); - double memory_usage(); - virtual void *extract(const char *, int &); - void grow_arrays(int); - void copy_arrays(int, int, int); - int pack_exchange(int, double *); - int unpack_exchange(int, double *); + class FixLangevin : public Fix { + public: + FixLangevin(class LAMMPS *, int, char **); + virtual ~FixLangevin(); + int setmask(); + void init(); + void setup(int); + void initial_integrate_respa(int, int, int); + virtual void initial_integrate(int); + virtual void post_force(int); + void post_force_respa(int, int, int); + virtual void end_of_step(); + void reset_target(double); + void reset_dt(); + int modify_param(int, char **); + virtual double compute_scalar(); + double memory_usage(); + virtual void *extract(const char *, int &); + void grow_arrays(int); + void copy_arrays(int, int, int); + int pack_exchange(int, double *); + int unpack_exchange(int, double *); - protected: - int gjfflag,oflag,tallyflag,zeroflag,tbiasflag,hsflag; - int flangevin_allocated; - double ascale; - double t_start,t_stop,t_period,t_target; - double *gfactor1,*gfactor2,*ratio; - double energy,energy_onestep; - double tsqrt; - int tstyle,tvar; - double gjffac; - char *tstr; + protected: + int gjfflag,oflag,tallyflag,zeroflag,tbiasflag; + int flangevin_allocated; + double ascale; + double t_start,t_stop,t_period,t_target; + double *gfactor1,*gfactor2,*ratio; + double energy,energy_onestep; + double tsqrt; + int tstyle,tvar; + double gjfa, gjfsib; //gjf a and gjf sqrt inverse b + char *tstr; - class AtomVecEllipsoid *avec; + class AtomVecEllipsoid *avec; - int maxatom1,maxatom2; - double **flangevin; - double *tforce; - double **franprev; - double **lv; //2GJ velocity or half-step velocity - double **wildcard; - double **bias; //Bias velocity + int maxatom1,maxatom2; + double **flangevin; + double *tforce; + double **franprev; + double **lv; //half step velocity - int nvalues; + char *id_temp; + class Compute *temperature; - char *id_temp; - class Compute *temperature; + int nlevels_respa; + class RanMars *random; + int seed; - int nlevels_respa; - class RanMars *random; - int seed; + template < int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, + int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > + void post_force_templated(); - template < int Tp_TSTYLEATOM, int Tp_GJF, int Tp_TALLY, - int Tp_BIAS, int Tp_RMASS, int Tp_ZERO > - void post_force_templated(); - - void omega_thermostat(); - void angmom_thermostat(); - void compute_target(); -}; + void omega_thermostat(); + void angmom_thermostat(); + void compute_target(); + }; } @@ -93,62 +87,35 @@ class FixLangevin : public Fix { #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: Fix langevin period must be > 0.0 - The time window for temperature relaxation must be > 0 - E: Fix langevin omega requires atom style sphere - Self-explanatory. - E: Fix langevin angmom requires atom style ellipsoid - Self-explanatory. - E: Variable name for fix langevin does not exist - Self-explanatory. - E: Variable for fix langevin is invalid style - It must be an equal-style variable. - E: Fix langevin omega requires extended particles - One of the particles has radius 0.0. - E: Fix langevin angmom requires extended particles - This fix option cannot be used with point particles. - E: Cannot zero Langevin force of 0 atoms - The group has zero atoms, so you cannot request its force be zeroed. - E: Fix langevin variable returned negative temperature - Self-explanatory. - E: Could not find fix_modify temperature ID - The compute ID for computing temperature does not exist. - E: Fix_modify temperature ID does not compute temperature - The compute ID assigned to the fix must compute temperature. - W: Group for fix_modify temp != fix group - The fix_modify command is specifying a temperature computation that computes a temperature on a different group of atoms than the fix itself operates on. This is probably not what you want to do. - */ From 801c1656533e65234d97ef2d996c57afce76a80e Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Wed, 21 Aug 2019 20:11:43 -0700 Subject: [PATCH 098/557] Added onsite GJF formalism --- src/fix_langevin.cpp | 49 +++++++++++++++++++++++++++++++++++--------- 1 file changed, 39 insertions(+), 10 deletions(-) diff --git a/src/fix_langevin.cpp b/src/fix_langevin.cpp index b8144fc5f3..6971b145ec 100644 --- a/src/fix_langevin.cpp +++ b/src/fix_langevin.cpp @@ -90,6 +90,7 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : for (int i = 1; i <= atom->ntypes; i++) ratio[i] = 1.0; ascale = 0.0; gjfflag = 0; + fsflag = 0; oflag = 0; tallyflag = 0; zeroflag = 0; @@ -103,8 +104,11 @@ FixLangevin::FixLangevin(LAMMPS *lmp, int narg, char **arg) : iarg += 2; } else if (strcmp(arg[iarg],"gjf") == 0) { if (iarg+2 > narg) error->all(FLERR,"Illegal fix langevin command"); - if (strcmp(arg[iarg+1],"no") == 0) gjfflag = 0; - else if (strcmp(arg[iarg+1],"yes") == 0) gjfflag = 1; + if (strcmp(arg[iarg+1],"no") == 0) {gjfflag = 0; fsflag = 0;} + else if (strcmp(arg[iarg+1],"yes") == 0) + error->all(FLERR,"Fix langevin gjf yes is outdated, please use vhalf or vfull"); + else if (strcmp(arg[iarg+1],"vhalf") == 0) {gjfflag = 1; fsflag = 0;} + else if (strcmp(arg[iarg+1],"vfull") == 0) {gjfflag = 1; fsflag = 1;} else error->all(FLERR,"Illegal fix langevin command"); iarg += 2; } else if (strcmp(arg[iarg],"omega") == 0) { @@ -431,7 +435,7 @@ void FixLangevin::post_force(int /*vflag*/) if (tstyle == ATOM) if (gjfflag) - if (tallyflag) + if (tallyflag || fsflag) if (tbiasflag == BIAS) if (rmass) if (zeroflag) post_force_templated<1,1,1,1,1,1>(); @@ -462,7 +466,7 @@ void FixLangevin::post_force(int /*vflag*/) if (zeroflag) post_force_templated<1,1,0,0,0,1>(); else post_force_templated<1,1,0,0,0,0>(); else - if (tallyflag) + if (tallyflag || fsflag) if (tbiasflag == BIAS) if (rmass) if (zeroflag) post_force_templated<1,0,1,1,1,1>(); @@ -494,7 +498,7 @@ void FixLangevin::post_force(int /*vflag*/) else post_force_templated<1,0,0,0,0,0>(); else if (gjfflag) - if (tallyflag) + if (tallyflag || fsflag) if (tbiasflag == BIAS) if (rmass) if (zeroflag) post_force_templated<0,1,1,1,1,1>(); @@ -525,7 +529,7 @@ void FixLangevin::post_force(int /*vflag*/) if (zeroflag) post_force_templated<0,1,0,0,0,1>(); else post_force_templated<0,1,0,0,0,0>(); else - if (tallyflag) + if (tallyflag || fsflag) if (tbiasflag == BIAS) if (rmass) if (zeroflag) post_force_templated<0,0,1,1,1,1>(); @@ -906,6 +910,13 @@ void FixLangevin::end_of_step() double **v = atom->v; int *mask = atom->mask; int nlocal = atom->nlocal; + double ftm2v = force->ftm2v; + double gamma1; double dtfm; + double dt = update->dt; + double *mass = atom->mass; + double *rmass = atom->rmass; + double **f = atom->f; + int *type = atom->type; energy_onestep = 0.0; @@ -916,9 +927,27 @@ void FixLangevin::end_of_step() tmp[0] = v[i][0]; tmp[1] = v[i][1]; tmp[2] = v[i][2]; - v[i][0] = lv[i][0]; - v[i][1] = lv[i][1]; - v[i][2] = lv[i][2]; + if (!fsflag){ + v[i][0] = lv[i][0]; + v[i][1] = lv[i][1]; + v[i][2] = lv[i][2]; + } + else{ + if (atom->rmass) { + dtfm = 0.5 * dt / rmass[i]; + gamma1 = -rmass[i] / t_period / ftm2v; + gamma1 *= 1.0/ratio[type[i]]; + } else { + dtfm = 0.5 * dt / mass[type[i]]; + gamma1 = gfactor1[type[i]]; + } + v[i][0] = flangevin[i][0] - franprev[i][0] + gjfa * (gjfsib/2 + gamma1/gjfsib) * lv[i][0] + + gjfsib*gjfsib*(dtfm * f[i][0] + v[i][0])/2; + v[i][1] = flangevin[i][1] - franprev[i][1] + gjfa * (gjfsib/2 + gamma1/gjfsib) * lv[i][1] + + gjfsib*gjfsib*(dtfm * f[i][1] + v[i][1])/2; + v[i][2] = flangevin[i][2] - franprev[i][2] + gjfa * (gjfsib/2 + gamma1/gjfsib) * lv[i][2] + + gjfsib*gjfsib*(dtfm * f[i][2] + v[i][2])/2; + } lv[i][0] = tmp[0]; lv[i][1] = tmp[1]; lv[i][2] = tmp[2]; @@ -1032,7 +1061,7 @@ double FixLangevin::memory_usage() { double bytes = 0.0; if (gjfflag) bytes += atom->nmax*6 * sizeof(double); - if (tallyflag) bytes += atom->nmax*3 * sizeof(double); + if (tallyflag || fsflag) bytes += atom->nmax*3 * sizeof(double); if (tforce) bytes += atom->nmax * sizeof(double); return bytes; } From ceeb7da5911c47c7b7eda617a172954bc04a1134 Mon Sep 17 00:00:00 2001 From: charlie sievers Date: Wed, 21 Aug 2019 20:47:17 -0700 Subject: [PATCH 099/557] Added onsite GJF formalism --- src/fix_langevin.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/fix_langevin.h b/src/fix_langevin.h index 8b8c1cd6c8..5abfa53288 100644 --- a/src/fix_langevin.h +++ b/src/fix_langevin.h @@ -46,7 +46,7 @@ namespace LAMMPS_NS { int unpack_exchange(int, double *); protected: - int gjfflag,oflag,tallyflag,zeroflag,tbiasflag; + int gjfflag,fsflag,oflag,tallyflag,zeroflag,tbiasflag; int flangevin_allocated; double ascale; double t_start,t_stop,t_period,t_target; From f74c5fc9567c3452fcd0fbe6243fd8c6be461140 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 22 Aug 2019 09:38:55 -0400 Subject: [PATCH 100/557] add RanPark pRNG warmup also to fix evaporate and create_atoms --- src/MISC/fix_evaporate.cpp | 3 +++ src/create_atoms.cpp | 3 +++ 2 files changed, 6 insertions(+) diff --git a/src/MISC/fix_evaporate.cpp b/src/MISC/fix_evaporate.cpp index 1bf7a15f1f..6c08b201b7 100644 --- a/src/MISC/fix_evaporate.cpp +++ b/src/MISC/fix_evaporate.cpp @@ -58,8 +58,11 @@ FixEvaporate::FixEvaporate(LAMMPS *lmp, int narg, char **arg) : if (seed <= 0) error->all(FLERR,"Illegal fix evaporate command"); // random number generator, same for all procs + // warm up the generator 30x to avoid correlations in first-particle + // positions if runs are repeated with consecutive seeds random = new RanPark(lmp,seed); + for (int ii=0; ii < 30; ii++) random->uniform(); // optional args diff --git a/src/create_atoms.cpp b/src/create_atoms.cpp index 52e4256fca..65467ea657 100644 --- a/src/create_atoms.cpp +++ b/src/create_atoms.cpp @@ -611,8 +611,11 @@ void CreateAtoms::add_random() double *boxlo,*boxhi; // random number generator, same for all procs + // warm up the generator 30x to avoid correlations in first-particle + // positions if runs are repeated with consecutive seeds RanPark *random = new RanPark(lmp,seed); + for (int ii=0; ii < 30; ii++) random->uniform(); // bounding box for atom creation // in real units, even if triclinic From 8ec4e3fc9164fb21a2ceadf5211b3abe7987690f Mon Sep 17 00:00:00 2001 From: julient31 Date: Thu, 22 Aug 2019 10:48:58 -0600 Subject: [PATCH 101/557] Commit JT 082219 - modified min spin names (removed oso from spin/cg and spin/lbfgs) - modified associated option name (from spin_oso_cg to spin/cg, same for lbfgs) - modified .gitignore, doc pages, and examples accordingly --- doc/src/min_modify.txt | 14 ++-- doc/src/min_spin.txt | 26 +++---- doc/src/min_style.txt | 10 +-- doc/src/minimize.txt | 2 +- doc/src/neb_spin.txt | 4 +- examples/SPIN/spinmin/in.spinmin_cg.bfo | 2 +- examples/SPIN/spinmin/in.spinmin_lbfgs.bfo | 2 +- src/.gitignore | 8 +-- .../{min_spin_oso_cg.cpp => min_spin_cg.cpp} | 58 +++++++-------- src/SPIN/{min_spin_oso_cg.h => min_spin_cg.h} | 12 ++-- ..._spin_oso_lbfgs.cpp => min_spin_lbfgs.cpp} | 70 +++++++++---------- ...{min_spin_oso_lbfgs.h => min_spin_lbfgs.h} | 12 ++-- 12 files changed, 110 insertions(+), 110 deletions(-) rename src/SPIN/{min_spin_oso_cg.cpp => min_spin_cg.cpp} (91%) rename src/SPIN/{min_spin_oso_cg.h => min_spin_cg.h} (90%) rename src/SPIN/{min_spin_oso_lbfgs.cpp => min_spin_lbfgs.cpp} (90%) rename src/SPIN/{min_spin_oso_lbfgs.h => min_spin_lbfgs.h} (90%) diff --git a/doc/src/min_modify.txt b/doc/src/min_modify.txt index 857c3551aa..22ee232467 100644 --- a/doc/src/min_modify.txt +++ b/doc/src/min_modify.txt @@ -72,7 +72,7 @@ that difference may be smaller than machine epsilon even if atoms could move in the gradient direction to reduce forces further. The choice of a norm can be modified for the min styles {cg}, {sd}, -{quickmin}, {fire}, {spin}, {spin_oso_cg} and {spin_oso_lbfgs} using +{quickmin}, {fire}, {spin}, {spin/cg} and {spin/lbfgs} using the {norm} keyword. The default {euclidean} norm computes the 2-norm (length) of the global force vector. The {max} norm computes the maximum value @@ -88,19 +88,19 @@ adaptive timestep used in the {spin} minimization. See "min_spin"_min_spin.html for more information about those quantities. -The choice of a line search algorithm for the {spin_oso_cg} and -{spin_oso_lbfgs} styles can be specified via the {line} keyword. +The choice of a line search algorithm for the {spin/cg} and +{spin/lbfgs} styles can be specified via the {line} keyword. The {spin_cubic} and {spin_none} only make sense when one of those two minimization styles is declared. The {spin_cubic} performs the line search based on a cubic interpolation of the energy along the search direction. The {spin_none} keyword deactivates the line search procedure. -The {spin_none} is a default value for {line} keyword for both {spin_oso_lbfgs} -and {spin_oso_cg}. Convergence of {spin_oso_lbfgs} can be more robust if +The {spin_none} is a default value for {line} keyword for both {spin/lbfgs} +and {spin/cg}. Convergence of {spin/lbfgs} can be more robust if {spin_cubic} line search is used. [Restrictions:] The line search procedure of styles -{spin_oso_cg} and {spin_oso_lbfgs} cannot be used for magnetic +{spin/cg} and {spin/lbfgs} cannot be used for magnetic GNEB calculations. See "neb/spin"_neb_spin.html for more explanation. @@ -112,6 +112,6 @@ explanation. The option defaults are dmax = 0.1, line = quadratic and norm = euclidean. -For the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles, the +For the {spin}, {spin/cg} and {spin/lbfgs} styles, the option defaults are alpha_damp = 1.0, discrete_factor = 10.0, line = spin_none, and norm = euclidean. diff --git a/doc/src/min_spin.txt b/doc/src/min_spin.txt index 575db2dc74..ba034cfbb9 100644 --- a/doc/src/min_spin.txt +++ b/doc/src/min_spin.txt @@ -6,18 +6,18 @@ :line min_style spin command :h3 -min_style spin_oso_cg command :h3 -min_style spin_oso_lbfgs command :h3 +min_style spin/cg command :h3 +min_style spin/lbfgs command :h3 [Syntax:] min_style spin -min_style spin_oso_cg -min_style spin_oso_lbfgs :pre +min_style spin/cg +min_style spin/lbfgs :pre [Examples:] -min_style spin_oso_lbfgs +min_style spin/lbfgs min_modify line spin_cubic discrete_factor 10.0 :pre [Description:] @@ -51,35 +51,35 @@ definition of this timestep. {discrete_factor} can be defined with the "min_modify"_min_modify.html command. -Style {spin_oso_cg} defines an orthogonal spin optimization +Style {spin/cg} defines an orthogonal spin optimization (OSO) combined to a conjugate gradient (CG) algorithm. The "min_modify"_min_modify.html command can be used to -couple the {spin_oso_cg} to a line search procedure, and to modify the +couple the {spin/cg} to a line search procedure, and to modify the discretization factor {discrete_factor}. -By default, style {spin_oso_cg} does not employ the line search procedure +By default, style {spin/cg} does not employ the line search procedure and uses the adaptive time-step technique in the same way as style {spin}. -Style {spin_oso_lbfgs} defines an orthogonal spin optimization +Style {spin/lbfgs} defines an orthogonal spin optimization (OSO) combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno (L-BFGS) algorithm. -By default, style {spin_oso_lbfgs} does not employ line search procedure. +By default, style {spin/lbfgs} does not employ line search procedure. If the line search procedure is not used then the discrete factor defines the maximum root mean squared rotation angle of spins by equation {pi/(5*Kappa)}. The default value for Kappa is 10. The {spin_cubic} line search can improve the convergence of the -{spin_oso_lbfgs} algorithm. +{spin/lbfgs} algorithm. The "min_modify"_min_modify.html command can be used to activate the line search procedure, and to modify the discretization factor {discrete_factor}. -For more information about styles {spin_oso_cg} and {spin_oso_lbfgs}, +For more information about styles {spin/cg} and {spin/lbfgs}, see their implementation reported in "(Ivanov)"_#Ivanov1. NOTE: All the {spin} styles replace the force tolerance by a torque tolerance. See "minimize"_minimize.html for more explanation. -NOTE: The {spin_oso_cg} and {spin_oso_lbfgs} styles can be used +NOTE: The {spin/cg} and {spin/lbfgs} styles can be used for magnetic NEB calculations only if the line search procedure is deactivated. See "neb/spin"_neb_spin.html for more explanation. diff --git a/doc/src/min_style.txt b/doc/src/min_style.txt index 7c40fd4947..9613da7b13 100644 --- a/doc/src/min_style.txt +++ b/doc/src/min_style.txt @@ -11,7 +11,7 @@ min_style command :h3 min_style style :pre -style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} or {spin_oso_cg} or {spin_oso_lbfgs} :ul +style = {cg} or {hftn} or {sd} or {quickmin} or {fire} or {spin} or {spin/cg} or {spin/lbfgs} :ul [Examples:] @@ -65,21 +65,21 @@ a minimization. Style {spin} is a damped spin dynamics with an adaptive timestep. -Style {spin_oso_cg} uses an orthogonal spin optimization (OSO) +Style {spin/cg} uses an orthogonal spin optimization (OSO) combined to a conjugate gradient (CG) approach to minimize spin configurations. -Style {spin_oso_lbfgs} uses an orthogonal spin optimization (OSO) +Style {spin/lbfgs} uses an orthogonal spin optimization (OSO) combined to a limited-memory Broyden-Fletcher-Goldfarb-Shanno (LBFGS) approach to minimize spin configurations. See the "min/spin"_min_spin.html doc page for more information -about the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles. +about the {spin}, {spin/cg} and {spin/lbfgs} styles. Either the {quickmin} and {fire} styles are useful in the context of nudged elastic band (NEB) calculations via the "neb"_neb.html command. -Either the {spin}, {spin_oso_cg} and {spin_oso_lbfgs} styles are useful +Either the {spin}, {spin/cg} and {spin/lbfgs} styles are useful in the context of magnetic geodesic nudged elastic band (GNEB) calculations via the "neb/spin"_neb_spin.html command. diff --git a/doc/src/minimize.txt b/doc/src/minimize.txt index 1de925d6c8..bfdc02bedf 100644 --- a/doc/src/minimize.txt +++ b/doc/src/minimize.txt @@ -104,7 +104,7 @@ the number of outer iterations or timesteps exceeds {maxiter} the number of total force evaluations exceeds {maxeval} :ul NOTE: the "minimization style"_min_style.html {spin}, -{spin_oso_cg}, and {spin_oso_lbfgs} replace +{spin/cg}, and {spin/lbfgs} replace the force tolerance {ftol} by a torque tolerance. The minimization procedure stops if the 2-norm (length) of the torque vector on atom (defined as the cross product between the diff --git a/doc/src/neb_spin.txt b/doc/src/neb_spin.txt index 2fdfda8c66..b64df39219 100644 --- a/doc/src/neb_spin.txt +++ b/doc/src/neb_spin.txt @@ -173,7 +173,7 @@ A NEB calculation proceeds in two stages, each of which is a minimization procedure. To enable this, you must first define a "min_style"_min_style.html, using either the {spin}, -{spin_oso_cg}, or {spin_oso_lbfgs} style (see +{spin/cg}, or {spin/lbfgs} style (see "min_spin"_min_spin.html for more information). The other styles cannot be used, since they relax the lattice degrees of freedom instead of the spins. @@ -359,7 +359,7 @@ This command can only be used if LAMMPS was built with the SPIN package. See the "Build package"_Build_package.html doc page for more info. -The line search procedures of the {spin_oso_cg} and {spin_oso_lbfgs} +The line search procedures of the {spin/cg} and {spin/lbfgs} minimization styles cannot be used in a GNEB calculation. :line diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spinmin_cg.bfo index 8c288763c4..9d57399a56 100644 --- a/examples/SPIN/spinmin/in.spinmin_cg.bfo +++ b/examples/SPIN/spinmin/in.spinmin_cg.bfo @@ -49,6 +49,6 @@ thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -min_style spin_oso_cg +min_style spin/cg # min_modify line spin_none discrete_factor 10.0 minimize 1.0e-10 1.0e-10 10000 10000 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo index 6a9104cc9c..a73b863b11 100644 --- a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo +++ b/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo @@ -49,6 +49,6 @@ thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -min_style spin_oso_lbfgs +min_style spin/lbfgs # min_modify line spin_cubic discrete_factor 10.0 minimize 1.0e-15 1.0e-10 10000 1000 diff --git a/src/.gitignore b/src/.gitignore index 595276853c..5848874d94 100644 --- a/src/.gitignore +++ b/src/.gitignore @@ -161,10 +161,10 @@ /fix_setforce_spin.h /min_spin.cpp /min_spin.h -/min_spin_oso_cg.cpp -/min_spin_oso_cg.h -/min_spin_oso_lbfgs.cpp -/min_spin_oso_lbfgs.h +/min_spin_cg.cpp +/min_spin_cg.h +/min_spin_lbfgs.cpp +/min_spin_lbfgs.h /neb_spin.cpp /neb_spin.h /pair_spin.cpp diff --git a/src/SPIN/min_spin_oso_cg.cpp b/src/SPIN/min_spin_cg.cpp similarity index 91% rename from src/SPIN/min_spin_oso_cg.cpp rename to src/SPIN/min_spin_cg.cpp index f1f2f72436..322915c0f3 100644 --- a/src/SPIN/min_spin_oso_cg.cpp +++ b/src/SPIN/min_spin_cg.cpp @@ -25,7 +25,7 @@ #include #include #include -#include "min_spin_oso_cg.h" +#include "min_spin_cg.h" #include "universe.h" #include "atom.h" #include "citeme.h" @@ -44,8 +44,8 @@ using namespace LAMMPS_NS; using namespace MathConst; -static const char cite_minstyle_spin_oso_cg[] = - "min_style spin/oso_cg command:\n\n" +static const char cite_minstyle_spin_cg[] = + "min_style spin/cg command:\n\n" "@article{ivanov2019fast,\n" "title={Fast and Robust Algorithm for the Minimisation of the Energy of " "Spin Systems},\n" @@ -63,10 +63,10 @@ static const char cite_minstyle_spin_oso_cg[] = /* ---------------------------------------------------------------------- */ -MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : +MinSpinCG::MinSpinCG(LAMMPS *lmp) : Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), sp_copy(NULL) { - if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_cg); + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_cg); nlocal_max = 0; // nreplica = number of partitions @@ -81,7 +81,7 @@ MinSpinOSO_CG::MinSpinOSO_CG(LAMMPS *lmp) : /* ---------------------------------------------------------------------- */ -MinSpinOSO_CG::~MinSpinOSO_CG() +MinSpinCG::~MinSpinCG() { memory->destroy(g_old); memory->destroy(g_cur); @@ -92,7 +92,7 @@ MinSpinOSO_CG::~MinSpinOSO_CG() /* ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::init() +void MinSpinCG::init() { local_iter = 0; der_e_cur = 0.0; @@ -120,16 +120,16 @@ void MinSpinOSO_CG::init() // allocate tables nlocal_max = atom->nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + memory->grow(g_old,3*nlocal_max,"min/spin/cg:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/cg:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/cg:p_s"); if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg:sp_copy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/cg:sp_copy"); } /* ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::setup_style() +void MinSpinCG::setup_style() { double **v = atom->v; int nlocal = atom->nlocal; @@ -137,7 +137,7 @@ void MinSpinOSO_CG::setup_style() // check if the atom/spin style is defined if (!atom->sp_flag) - error->all(FLERR,"min/spin_oso_cg requires atom/spin style"); + error->all(FLERR,"min spin/cg requires atom/spin style"); for (int i = 0; i < nlocal; i++) v[i][0] = v[i][1] = v[i][2] = 0.0; @@ -145,7 +145,7 @@ void MinSpinOSO_CG::setup_style() /* ---------------------------------------------------------------------- */ -int MinSpinOSO_CG::modify_param(int narg, char **arg) +int MinSpinCG::modify_param(int narg, char **arg) { if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal fix_modify command"); @@ -160,7 +160,7 @@ int MinSpinOSO_CG::modify_param(int narg, char **arg) called after atoms have migrated ------------------------------------------------------------------------- */ -void MinSpinOSO_CG::reset_vectors() +void MinSpinCG::reset_vectors() { // atomic dof @@ -179,7 +179,7 @@ void MinSpinOSO_CG::reset_vectors() minimization via orthogonal spin optimisation ------------------------------------------------------------------------- */ -int MinSpinOSO_CG::iterate(int maxiter) +int MinSpinCG::iterate(int maxiter) { int nlocal = atom->nlocal; bigint ntimestep; @@ -191,11 +191,11 @@ int MinSpinOSO_CG::iterate(int maxiter) if (nlocal_max < nlocal) { local_iter = 0; nlocal_max = nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/cg:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/cg:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/cg:p_s"); + memory->grow(g_old,3*nlocal_max,"min/spin/cg:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/cg:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/cg:p_s"); if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/cg:sp_copy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/cg:sp_copy"); } for (int iter = 0; iter < maxiter; iter++) { @@ -309,7 +309,7 @@ int MinSpinOSO_CG::iterate(int maxiter) calculate gradients ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::calc_gradient() +void MinSpinCG::calc_gradient() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -337,7 +337,7 @@ void MinSpinOSO_CG::calc_gradient() Optimization' Second Edition, 2006 (p. 121) ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::calc_search_direction() +void MinSpinCG::calc_search_direction() { int nlocal = atom->nlocal; double g2old = 0.0; @@ -398,7 +398,7 @@ void MinSpinOSO_CG::calc_search_direction() rotation of spins along the search direction ---------------------------------------------------------------------- */ -void MinSpinOSO_CG::advance_spins() +void MinSpinCG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -429,7 +429,7 @@ void MinSpinOSO_CG::advance_spins() [-y, -z, 0]] ------------------------------------------------------------------------- */ -void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) +void MinSpinCG::rodrigues_rotation(const double *upp_tr, double *out) { double theta,A,B,D,x,y,z; double s1,s2,s3,a1,a2,a3; @@ -490,7 +490,7 @@ void MinSpinOSO_CG::rodrigues_rotation(const double *upp_tr, double *out) m -- 3x3 matrix , v -- 3-d vector ------------------------------------------------------------------------- */ -void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) +void MinSpinCG::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ out[i] = 0.0; @@ -502,7 +502,7 @@ void MinSpinOSO_CG::vm3(const double *m, const double *v, double *out) advance spins ------------------------------------------------------------------------- */ -void MinSpinOSO_CG::make_step(double c, double *energy_and_der) +void MinSpinCG::make_step(double c, double *energy_and_der) { double p_scaled[3]; int nlocal = atom->nlocal; @@ -549,7 +549,7 @@ void MinSpinOSO_CG::make_step(double c, double *energy_and_der) using the cubic interpolation ------------------------------------------------------------------------- */ -int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) +int MinSpinCG::calc_and_make_step(double a, double b, int index) { double e_and_d[2] = {0.0,0.0}; double alpha,c1,c2,c3; @@ -601,7 +601,7 @@ int MinSpinOSO_CG::calc_and_make_step(double a, double b, int index) Approximate descent ------------------------------------------------------------------------- */ -int MinSpinOSO_CG::adescent(double phi_0, double phi_j){ +int MinSpinCG::adescent(double phi_0, double phi_j){ double eps = 1.0e-6; @@ -615,7 +615,7 @@ int MinSpinOSO_CG::adescent(double phi_0, double phi_j){ evaluate max timestep ---------------------------------------------------------------------- */ -double MinSpinOSO_CG::evaluate_dt() +double MinSpinCG::evaluate_dt() { double dtmax; double fmsq; diff --git a/src/SPIN/min_spin_oso_cg.h b/src/SPIN/min_spin_cg.h similarity index 90% rename from src/SPIN/min_spin_oso_cg.h rename to src/SPIN/min_spin_cg.h index d6dc7c03d0..0eed7a61e6 100644 --- a/src/SPIN/min_spin_oso_cg.h +++ b/src/SPIN/min_spin_cg.h @@ -13,21 +13,21 @@ #ifdef MINIMIZE_CLASS -MinimizeStyle(spin_oso_cg, MinSpinOSO_CG) +MinimizeStyle(spin/cg, MinSpinCG) #else -#ifndef LMP_MIN_SPIN_OSO_CG_H -#define LMP_MIN_SPIN_OSO_CG_H +#ifndef LMP_MIN_SPIN_CG_H +#define LMP_MIN_SPIN_CG_H #include "min.h" namespace LAMMPS_NS { -class MinSpinOSO_CG: public Min { +class MinSpinCG: public Min { public: - MinSpinOSO_CG(class LAMMPS *); - virtual ~MinSpinOSO_CG(); + MinSpinCG(class LAMMPS *); + virtual ~MinSpinCG(); void init(); void setup_style(); void reset_vectors(); diff --git a/src/SPIN/min_spin_oso_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp similarity index 90% rename from src/SPIN/min_spin_oso_lbfgs.cpp rename to src/SPIN/min_spin_lbfgs.cpp index 8623a8bb29..891dec5c93 100644 --- a/src/SPIN/min_spin_oso_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -25,7 +25,7 @@ #include #include #include -#include "min_spin_oso_lbfgs.h" +#include "min_spin_lbfgs.h" #include "atom.h" #include "citeme.h" #include "comm.h" @@ -43,8 +43,8 @@ using namespace LAMMPS_NS; using namespace MathConst; -static const char cite_minstyle_spin_oso_lbfgs[] = - "min_style spin/oso_lbfgs command:\n\n" +static const char cite_minstyle_spin_lbfgs[] = + "min_style spin/lbfgs command:\n\n" "@article{ivanov2019fast,\n" "title={Fast and Robust Algorithm for the Minimisation of the Energy of " "Spin Systems},\n" @@ -62,10 +62,10 @@ static const char cite_minstyle_spin_oso_lbfgs[] = /* ---------------------------------------------------------------------- */ -MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : +MinSpinLBFGS::MinSpinLBFGS(LAMMPS *lmp) : Min(lmp), g_old(NULL), g_cur(NULL), p_s(NULL), rho(NULL), ds(NULL), dy(NULL), sp_copy(NULL) { - if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_oso_lbfgs); + if (lmp->citeme) lmp->citeme->add(cite_minstyle_spin_lbfgs); nlocal_max = 0; // nreplica = number of partitions @@ -81,7 +81,7 @@ MinSpinOSO_LBFGS::MinSpinOSO_LBFGS(LAMMPS *lmp) : /* ---------------------------------------------------------------------- */ -MinSpinOSO_LBFGS::~MinSpinOSO_LBFGS() +MinSpinLBFGS::~MinSpinLBFGS() { memory->destroy(g_old); memory->destroy(g_cur); @@ -95,7 +95,7 @@ MinSpinOSO_LBFGS::~MinSpinOSO_LBFGS() /* ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::init() +void MinSpinLBFGS::init() { num_mem = 3; local_iter = 0; @@ -123,20 +123,20 @@ void MinSpinOSO_LBFGS::init() // allocate tables nlocal_max = atom->nlocal; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs:p_s"); - memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); - memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); - memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); + memory->grow(g_old,3*nlocal_max,"min/spin/lbfgs:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/lbfgs:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/lbfgs:p_s"); + memory->grow(rho,num_mem,"min/spin/lbfgs:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/lbfgs:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/lbfgs:dy"); if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs:sp_copy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/lbfgs:sp_copy"); } /* ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::setup_style() +void MinSpinLBFGS::setup_style() { double **v = atom->v; int nlocal = atom->nlocal; @@ -144,7 +144,7 @@ void MinSpinOSO_LBFGS::setup_style() // check if the atom/spin style is defined if (!atom->sp_flag) - error->all(FLERR,"min/spin_oso_lbfgs requires atom/spin style"); + error->all(FLERR,"min spin/lbfgs requires atom/spin style"); for (int i = 0; i < nlocal; i++) v[i][0] = v[i][1] = v[i][2] = 0.0; @@ -152,7 +152,7 @@ void MinSpinOSO_LBFGS::setup_style() /* ---------------------------------------------------------------------- */ -int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) +int MinSpinLBFGS::modify_param(int narg, char **arg) { if (strcmp(arg[0],"discrete_factor") == 0) { if (narg < 2) error->all(FLERR,"Illegal min_modify command"); @@ -169,7 +169,7 @@ int MinSpinOSO_LBFGS::modify_param(int narg, char **arg) called after atoms have migrated ------------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::reset_vectors() +void MinSpinLBFGS::reset_vectors() { // atomic dof @@ -188,7 +188,7 @@ void MinSpinOSO_LBFGS::reset_vectors() minimization via damped spin dynamics ------------------------------------------------------------------------- */ -int MinSpinOSO_LBFGS::iterate(int maxiter) +int MinSpinLBFGS::iterate(int maxiter) { int nlocal = atom->nlocal; bigint ntimestep; @@ -200,14 +200,14 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) if (nlocal_max < nlocal) { nlocal_max = nlocal; local_iter = 0; - memory->grow(g_old,3*nlocal_max,"min/spin/oso/lbfgs:g_old"); - memory->grow(g_cur,3*nlocal_max,"min/spin/oso/lbfgs:g_cur"); - memory->grow(p_s,3*nlocal_max,"min/spin/oso/lbfgs:p_s"); - memory->grow(rho,num_mem,"min/spin/oso/lbfgs:rho"); - memory->grow(ds,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:ds"); - memory->grow(dy,num_mem,3*nlocal_max,"min/spin/oso/lbfgs:dy"); + memory->grow(g_old,3*nlocal_max,"min/spin/lbfgs:g_old"); + memory->grow(g_cur,3*nlocal_max,"min/spin/lbfgs:g_cur"); + memory->grow(p_s,3*nlocal_max,"min/spin/lbfgs:p_s"); + memory->grow(rho,num_mem,"min/spin/lbfgs:rho"); + memory->grow(ds,num_mem,3*nlocal_max,"min/spin/lbfgs:ds"); + memory->grow(dy,num_mem,3*nlocal_max,"min/spin/lbfgs:dy"); if (use_line_search) - memory->grow(sp_copy,nlocal_max,3,"min/spin/oso/lbfgs:sp_copy"); + memory->grow(sp_copy,nlocal_max,3,"min/spin/lbfgs:sp_copy"); } for (int iter = 0; iter < maxiter; iter++) { @@ -324,7 +324,7 @@ int MinSpinOSO_LBFGS::iterate(int maxiter) calculate gradients ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::calc_gradient() +void MinSpinLBFGS::calc_gradient() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -347,7 +347,7 @@ void MinSpinOSO_LBFGS::calc_gradient() Optimization' Second Edition, 2006 (p. 177) ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::calc_search_direction() +void MinSpinLBFGS::calc_search_direction() { int nlocal = atom->nlocal; @@ -531,7 +531,7 @@ void MinSpinOSO_LBFGS::calc_search_direction() rotation of spins along the search direction ---------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::advance_spins() +void MinSpinLBFGS::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; @@ -562,7 +562,7 @@ void MinSpinOSO_LBFGS::advance_spins() [-y, -z, 0]] ------------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) +void MinSpinLBFGS::rodrigues_rotation(const double *upp_tr, double *out) { double theta,A,B,D,x,y,z; double s1,s2,s3,a1,a2,a3; @@ -622,7 +622,7 @@ void MinSpinOSO_LBFGS::rodrigues_rotation(const double *upp_tr, double *out) m -- 3x3 matrix , v -- 3-d vector ------------------------------------------------------------------------- */ -void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) +void MinSpinLBFGS::vm3(const double *m, const double *v, double *out) { for(int i = 0; i < 3; i++){ out[i] = 0.0; @@ -632,7 +632,7 @@ void MinSpinOSO_LBFGS::vm3(const double *m, const double *v, double *out) } -void MinSpinOSO_LBFGS::make_step(double c, double *energy_and_der) +void MinSpinLBFGS::make_step(double c, double *energy_and_der) { double p_scaled[3]; int nlocal = atom->nlocal; @@ -679,7 +679,7 @@ void MinSpinOSO_LBFGS::make_step(double c, double *energy_and_der) using the cubic interpolation ------------------------------------------------------------------------- */ -int MinSpinOSO_LBFGS::calc_and_make_step(double a, double b, int index) +int MinSpinLBFGS::calc_and_make_step(double a, double b, int index) { double e_and_d[2] = {0.0,0.0}; double alpha,c1,c2,c3; @@ -731,7 +731,7 @@ int MinSpinOSO_LBFGS::calc_and_make_step(double a, double b, int index) Approximate descent ------------------------------------------------------------------------- */ -int MinSpinOSO_LBFGS::adescent(double phi_0, double phi_j){ +int MinSpinLBFGS::adescent(double phi_0, double phi_j){ double eps = 1.0e-6; @@ -741,7 +741,7 @@ int MinSpinOSO_LBFGS::adescent(double phi_0, double phi_j){ return 0; } -double MinSpinOSO_LBFGS::maximum_rotation(double *p) +double MinSpinLBFGS::maximum_rotation(double *p) { double norm2,norm2_global,scaling,alpha; int nlocal = atom->nlocal; diff --git a/src/SPIN/min_spin_oso_lbfgs.h b/src/SPIN/min_spin_lbfgs.h similarity index 90% rename from src/SPIN/min_spin_oso_lbfgs.h rename to src/SPIN/min_spin_lbfgs.h index 68fa10921e..cead605b32 100644 --- a/src/SPIN/min_spin_oso_lbfgs.h +++ b/src/SPIN/min_spin_lbfgs.h @@ -13,21 +13,21 @@ #ifdef MINIMIZE_CLASS -MinimizeStyle(spin_oso_lbfgs, MinSpinOSO_LBFGS) +MinimizeStyle(spin/lbfgs, MinSpinLBFGS) #else -#ifndef LMP_MIN_SPIN_OSO_LBFGS_H -#define LMP_MIN_SPIN_OSO_LBFGS_H +#ifndef LMP_MIN_SPIN_LBFGS_H +#define LMP_MIN_SPIN_LBFGS_H #include "min.h" namespace LAMMPS_NS { -class MinSpinOSO_LBFGS: public Min { +class MinSpinLBFGS: public Min { public: - MinSpinOSO_LBFGS(class LAMMPS *); - virtual ~MinSpinOSO_LBFGS(); + MinSpinLBFGS(class LAMMPS *); + virtual ~MinSpinLBFGS(); void init(); void setup_style(); int modify_param(int, char **); From 574e4067dcff1ed0a3e53e12b22188daf685dfe6 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 22 Aug 2019 11:24:26 -0600 Subject: [PATCH 102/557] Add documentation files in RST format This is the first step for moving the documentation format from *.txt to the *.rst format. In the last years we've been automatically converting txt files from Steve's markup into RST to generate the documentation pages via Sphinx. The decision has now been made to fully migrate to RST and avoid the conversion in the future. This will enable us to fully use RST and Sphinx to improve the documentation. For the intermediate period, while there are still pending PRs with documentation changes, we will keep both source files and update the RST files accordingly. --- doc/.gitignore | 2 + doc/Makefile | 16 +- doc/rst/.gitignore | 2 + doc/rst/Build.rst | 28 + doc/rst/Build_basics.rst | 437 + doc/rst/Build_cmake.rst | 245 + doc/rst/Build_development.rst | 120 + doc/rst/Build_extras.rst | 1369 +++ doc/rst/Build_link.rst | 91 + doc/rst/Build_make.rst | 94 + doc/rst/Build_package.rst | 265 + doc/rst/Build_settings.rst | 437 + doc/rst/Build_windows.rst | 111 + doc/rst/Commands.rst | 34 + doc/rst/Commands_all.rst | 59 + doc/rst/Commands_bond.rst | 112 + doc/rst/Commands_category.rst | 137 + doc/rst/Commands_compute.rst | 68 + doc/rst/Commands_fix.rst | 94 + doc/rst/Commands_input.rst | 62 + doc/rst/Commands_kspace.rst | 28 + doc/rst/Commands_pair.rst | 136 + doc/rst/Commands_parse.rst | 149 + doc/rst/Commands_removed.rst | 67 + doc/rst/Commands_structure.rst | 91 + doc/rst/Errors.rst | 22 + doc/rst/Errors_bugs.rst | 32 + doc/rst/Errors_common.rst | 128 + doc/rst/Errors_messages.rst | 8396 +++++++++++++++++ doc/rst/Errors_warnings.rst | 752 ++ doc/rst/Examples.rst | 233 + doc/rst/Howto.rst | 106 + doc/rst/Howto_2d.rst | 48 + doc/rst/Howto_barostat.rst | 68 + doc/rst/Howto_bash.rst | 291 + doc/rst/Howto_bioFF.rst | 151 + doc/rst/Howto_body.rst | 519 + doc/rst/Howto_chunk.rst | 209 + doc/rst/Howto_client_server.rst | 135 + doc/rst/Howto_coreshell.rst | 271 + doc/rst/Howto_couple.rst | 125 + doc/rst/Howto_diffusion.rst | 32 + doc/rst/Howto_dispersion.rst | 105 + doc/rst/Howto_drude.rst | 72 + doc/rst/Howto_drude2.rst | 542 ++ doc/rst/Howto_elastic.rst | 49 + doc/rst/Howto_github.rst | 499 + doc/rst/Howto_granular.rst | 55 + doc/rst/Howto_kappa.rst | 86 + doc/rst/Howto_library.rst | 227 + doc/rst/Howto_manifold.rst | 57 + doc/rst/Howto_multiple.rst | 103 + doc/rst/Howto_nemd.rst | 60 + doc/rst/Howto_output.rst | 349 + doc/rst/Howto_polarizable.rst | 78 + doc/rst/Howto_pylammps.rst | 585 ++ doc/rst/Howto_replica.rst | 60 + doc/rst/Howto_restart.rst | 105 + doc/rst/Howto_spc.rst | 57 + doc/rst/Howto_spherical.rst | 243 + doc/rst/Howto_spins.rst | 73 + doc/rst/Howto_temperature.rst | 38 + doc/rst/Howto_thermostat.rst | 99 + doc/rst/Howto_tip3p.rst | 81 + doc/rst/Howto_tip4p.rst | 116 + doc/rst/Howto_triclinic.rst | 228 + doc/rst/Howto_viscosity.rst | 148 + doc/rst/Howto_viz.rst | 43 + doc/rst/Howto_walls.rst | 76 + doc/rst/Install.rst | 57 + doc/rst/Install_git.rst | 128 + doc/rst/Install_linux.rst | 269 + doc/rst/Install_mac.rst | 54 + doc/rst/Install_patch.rst | 68 + doc/rst/Install_svn.rst | 102 + doc/rst/Install_tarball.rst | 84 + doc/rst/Install_windows.rst | 49 + doc/rst/Intro.rst | 21 + doc/rst/Intro_authors.rst | 69 + doc/rst/Intro_features.rst | 231 + doc/rst/Intro_nonfeatures.rst | 87 + doc/rst/Intro_opensource.rst | 49 + doc/rst/Intro_overview.rst | 54 + doc/rst/Intro_website.rst | 39 + doc/rst/Manual.rst | 92 + doc/rst/Manual_build.rst | 165 + doc/rst/Manual_version.rst | 28 + doc/rst/Modify.rst | 40 + doc/rst/Modify_atom.rst | 124 + doc/rst/Modify_body.rst | 40 + doc/rst/Modify_bond.rst | 41 + doc/rst/Modify_command.rst | 25 + doc/rst/Modify_compute.rst | 62 + doc/rst/Modify_contribute.rst | 203 + doc/rst/Modify_dump.rst | 37 + doc/rst/Modify_fix.rst | 158 + doc/rst/Modify_kspace.rst | 26 + doc/rst/Modify_min.rst | 24 + doc/rst/Modify_overview.rst | 107 + doc/rst/Modify_pair.rst | 40 + doc/rst/Modify_region.rst | 27 + doc/rst/Modify_thermo.rst | 32 + doc/rst/Modify_variable.rst | 45 + doc/rst/Packages.rst | 25 + doc/rst/Packages_details.rst | 2446 +++++ doc/rst/Packages_standard.rst | 96 + doc/rst/Packages_user.rst | 126 + doc/rst/Python_call.rst | 84 + doc/rst/Python_examples.rst | 116 + doc/rst/Python_head.rst | 49 + doc/rst/Python_install.rst | 70 + doc/rst/Python_library.rst | 271 + doc/rst/Python_mpi.rst | 79 + doc/rst/Python_overview.rst | 30 + doc/rst/Python_pylammps.rst | 10 + doc/rst/Python_run.rst | 37 + doc/rst/Python_shlib.rst | 86 + doc/rst/Python_test.rst | 170 + doc/rst/Run_basics.rst | 96 + doc/rst/Run_head.rst | 21 + doc/rst/Run_options.rst | 645 ++ doc/rst/Run_output.rst | 197 + doc/rst/Run_windows.rst | 81 + doc/rst/Speed.rst | 35 + doc/rst/Speed_bench.rst | 82 + doc/rst/Speed_compare.rst | 101 + doc/rst/Speed_gpu.rst | 185 + doc/rst/Speed_intel.rst | 553 ++ doc/rst/Speed_kokkos.rst | 451 + doc/rst/Speed_measure.rst | 51 + doc/rst/Speed_omp.rst | 167 + doc/rst/Speed_opt.rst | 58 + doc/rst/Speed_packages.rst | 195 + doc/rst/Speed_tips.rst | 61 + doc/rst/Tools.rst | 712 ++ doc/rst/angle_charmm.rst | 115 + doc/rst/angle_class2.rst | 167 + doc/rst/angle_coeff.rst | 109 + doc/rst/angle_cosine.rst | 90 + doc/rst/angle_cosine_buck6d.rst | 80 + doc/rst/angle_cosine_delta.rst | 92 + doc/rst/angle_cosine_periodic.rst | 111 + doc/rst/angle_cosine_shift.rst | 90 + doc/rst/angle_cosine_shift_exp.rst | 104 + doc/rst/angle_cosine_squared.rst | 92 + doc/rst/angle_cross.rst | 75 + doc/rst/angle_dipole.rst | 154 + doc/rst/angle_fourier.rst | 85 + doc/rst/angle_fourier_simple.rst | 84 + doc/rst/angle_harmonic.rst | 98 + doc/rst/angle_hybrid.rst | 110 + doc/rst/angle_mm3.rst | 69 + doc/rst/angle_none.rst | 46 + doc/rst/angle_quartic.rst | 94 + doc/rst/angle_sdk.rst | 100 + doc/rst/angle_style.rst | 131 + doc/rst/angle_table.rst | 186 + doc/rst/angle_zero.rst | 61 + doc/rst/angles.rst | 29 + doc/rst/atom_modify.rst | 195 + doc/rst/atom_style.rst | 378 + doc/rst/balance.rst | 574 ++ doc/rst/bond_class2.rst | 105 + doc/rst/bond_coeff.rst | 104 + doc/rst/bond_fene.rst | 114 + doc/rst/bond_fene_expand.rst | 113 + doc/rst/bond_gromos.rst | 89 + doc/rst/bond_harmonic.rst | 95 + doc/rst/bond_harmonic_shift.rst | 95 + doc/rst/bond_harmonic_shift_cut.rst | 94 + doc/rst/bond_hybrid.rst | 90 + doc/rst/bond_mm3.rst | 76 + doc/rst/bond_morse.rst | 90 + doc/rst/bond_none.rst | 45 + doc/rst/bond_nonlinear.rst | 100 + doc/rst/bond_oxdna.rst | 128 + doc/rst/bond_quartic.rst | 131 + doc/rst/bond_style.rst | 136 + doc/rst/bond_table.rst | 183 + doc/rst/bond_write.rst | 76 + doc/rst/bond_zero.rst | 60 + doc/rst/bonds.rst | 24 + doc/rst/boundary.rst | 126 + doc/rst/box.rst | 76 + doc/rst/change_box.rst | 387 + doc/rst/clear.rst | 49 + doc/rst/comm_modify.rst | 186 + doc/rst/comm_style.rst | 78 + doc/rst/commands_list.rst | 123 + doc/rst/compute.rst | 336 + doc/rst/compute_ackland_atom.rst | 104 + doc/rst/compute_adf.rst | 234 + doc/rst/compute_angle.rst | 62 + doc/rst/compute_angle_local.rst | 158 + doc/rst/compute_angmom_chunk.rst | 100 + doc/rst/compute_basal_atom.rst | 90 + doc/rst/compute_body_local.rst | 110 + doc/rst/compute_bond.rst | 62 + doc/rst/compute_bond_local.rst | 208 + doc/rst/compute_centro_atom.rst | 180 + doc/rst/compute_chunk_atom.rst | 707 ++ doc/rst/compute_chunk_spread_atom.rst | 203 + doc/rst/compute_cluster_atom.rst | 117 + doc/rst/compute_cna_atom.rst | 119 + doc/rst/compute_cnp_atom.rst | 133 + doc/rst/compute_com.rst | 69 + doc/rst/compute_com_chunk.rst | 98 + doc/rst/compute_contact_atom.rst | 66 + doc/rst/compute_coord_atom.rst | 162 + doc/rst/compute_damage_atom.rst | 72 + doc/rst/compute_dihedral.rst | 61 + doc/rst/compute_dihedral_local.rst | 151 + doc/rst/compute_dilatation_atom.rst | 75 + doc/rst/compute_dipole_chunk.rst | 103 + doc/rst/compute_displace_atom.rst | 160 + doc/rst/compute_dpd.rst | 90 + doc/rst/compute_dpd_atom.rst | 79 + doc/rst/compute_edpd_temp_atom.rst | 80 + doc/rst/compute_entropy_atom.rst | 164 + doc/rst/compute_erotate_asphere.rst | 82 + doc/rst/compute_erotate_rigid.rst | 70 + doc/rst/compute_erotate_sphere.rst | 71 + doc/rst/compute_erotate_sphere_atom.rst | 67 + doc/rst/compute_event_displace.rst | 76 + doc/rst/compute_fep.rst | 349 + doc/rst/compute_global_atom.rst | 250 + doc/rst/compute_group_group.rst | 187 + doc/rst/compute_gyration.rst | 86 + doc/rst/compute_gyration_chunk.rst | 126 + doc/rst/compute_gyration_shape.rst | 103 + doc/rst/compute_heat_flux.rst | 217 + doc/rst/compute_hexorder_atom.rst | 139 + doc/rst/compute_hma.rst | 209 + doc/rst/compute_improper.rst | 61 + doc/rst/compute_improper_local.rst | 95 + doc/rst/compute_inertia_chunk.rst | 99 + doc/rst/compute_ke.rst | 71 + doc/rst/compute_ke_atom.rst | 60 + doc/rst/compute_ke_atom_eff.rst | 91 + doc/rst/compute_ke_eff.rst | 90 + doc/rst/compute_ke_rigid.rst | 69 + doc/rst/compute_meso_e_atom.rst | 67 + doc/rst/compute_meso_rho_atom.rst | 67 + doc/rst/compute_meso_t_atom.rst | 69 + doc/rst/compute_modify.rst | 87 + doc/rst/compute_momentum.rst | 59 + doc/rst/compute_msd.rst | 129 + doc/rst/compute_msd_chunk.rst | 137 + doc/rst/compute_msd_nongauss.rst | 96 + doc/rst/compute_omega_chunk.rst | 100 + doc/rst/compute_orientorder_atom.rst | 174 + doc/rst/compute_pair.rst | 107 + doc/rst/compute_pair_local.rst | 162 + doc/rst/compute_pe.rst | 97 + doc/rst/compute_pe_atom.rst | 123 + doc/rst/compute_plasticity_atom.rst | 82 + doc/rst/compute_pressure.rst | 176 + doc/rst/compute_pressure_cylinder.rst | 96 + doc/rst/compute_pressure_uef.rst | 70 + doc/rst/compute_property_atom.rst | 198 + doc/rst/compute_property_chunk.rst | 129 + doc/rst/compute_property_local.rst | 179 + doc/rst/compute_ptm_atom.rst | 135 + doc/rst/compute_rdf.rst | 224 + doc/rst/compute_reduce.rst | 244 + doc/rst/compute_reduce_chunk.rst | 205 + doc/rst/compute_rigid_local.rst | 205 + doc/rst/compute_saed.rst | 214 + doc/rst/compute_slice.rst | 137 + doc/rst/compute_smd_contact_radius.rst | 66 + doc/rst/compute_smd_damage.rst | 59 + doc/rst/compute_smd_hourglass_error.rst | 72 + doc/rst/compute_smd_internal_energy.rst | 60 + doc/rst/compute_smd_plastic_strain.rst | 65 + doc/rst/compute_smd_plastic_strain_rate.rst | 65 + doc/rst/compute_smd_rho.rst | 62 + doc/rst/compute_smd_tlsph_defgrad.rst | 67 + doc/rst/compute_smd_tlsph_dt.rst | 69 + doc/rst/compute_smd_tlsph_num_neighs.rst | 64 + doc/rst/compute_smd_tlsph_shape.rst | 71 + doc/rst/compute_smd_tlsph_strain.rst | 68 + doc/rst/compute_smd_tlsph_strain_rate.rst | 66 + doc/rst/compute_smd_tlsph_stress.rst | 68 + doc/rst/compute_smd_triangle_vertices.rst | 72 + doc/rst/compute_smd_ulsph_num_neighs.rst | 63 + doc/rst/compute_smd_ulsph_strain.rst | 66 + doc/rst/compute_smd_ulsph_strain_rate.rst | 67 + doc/rst/compute_smd_ulsph_stress.rst | 66 + doc/rst/compute_smd_vol.rst | 64 + doc/rst/compute_sna_atom.rst | 316 + doc/rst/compute_spin.rst | 94 + doc/rst/compute_stress_atom.rst | 196 + doc/rst/compute_stress_mop.rst | 127 + doc/rst/compute_tally.rst | 120 + doc/rst/compute_tdpd_cc_atom.rst | 75 + doc/rst/compute_temp.rst | 127 + doc/rst/compute_temp_asphere.rst | 173 + doc/rst/compute_temp_body.rst | 149 + doc/rst/compute_temp_chunk.rst | 260 + doc/rst/compute_temp_com.rst | 100 + doc/rst/compute_temp_cs.rst | 131 + doc/rst/compute_temp_deform.rst | 142 + doc/rst/compute_temp_deform_eff.rst | 80 + doc/rst/compute_temp_drude.rst | 87 + doc/rst/compute_temp_eff.rst | 108 + doc/rst/compute_temp_partial.rst | 126 + doc/rst/compute_temp_profile.rst | 202 + doc/rst/compute_temp_ramp.rst | 125 + doc/rst/compute_temp_region.rst | 114 + doc/rst/compute_temp_region_eff.rst | 71 + doc/rst/compute_temp_rotate.rst | 102 + doc/rst/compute_temp_sphere.rst | 159 + doc/rst/compute_temp_uef.rst | 62 + doc/rst/compute_ti.rst | 162 + doc/rst/compute_torque_chunk.rst | 99 + doc/rst/compute_vacf.rst | 87 + doc/rst/compute_vcm_chunk.rst | 86 + doc/rst/compute_voronoi_atom.rst | 256 + doc/rst/compute_xrd.rst | 278 + doc/rst/computes.rst | 136 + doc/rst/create_atoms.rst | 372 + doc/rst/create_bonds.rst | 226 + doc/rst/create_box.rst | 170 + doc/rst/delete_atoms.rst | 175 + doc/rst/delete_bonds.rst | 168 + doc/rst/dielectric.rst | 55 + doc/rst/dihedral_charmm.rst | 197 + doc/rst/dihedral_class2.rst | 202 + doc/rst/dihedral_coeff.rst | 119 + doc/rst/dihedral_cosine_shift_exp.rst | 102 + doc/rst/dihedral_fourier.rst | 95 + doc/rst/dihedral_harmonic.rst | 104 + doc/rst/dihedral_helix.rst | 105 + doc/rst/dihedral_hybrid.rst | 111 + doc/rst/dihedral_multi_harmonic.rst | 89 + doc/rst/dihedral_nharmonic.rst | 89 + doc/rst/dihedral_none.rst | 46 + doc/rst/dihedral_opls.rst | 111 + doc/rst/dihedral_quadratic.rst | 90 + doc/rst/dihedral_spherical.rst | 104 + doc/rst/dihedral_style.rst | 150 + doc/rst/dihedral_table.rst | 233 + doc/rst/dihedral_table_cut.rst | 236 + doc/rst/dihedral_zero.rst | 58 + doc/rst/dihedrals.rst | 39 + doc/rst/dimension.rst | 66 + doc/rst/displace_atoms.rst | 167 + doc/rst/dump.rst | 728 ++ doc/rst/dump_adios.rst | 95 + doc/rst/dump_cfg_uef.rst | 67 + doc/rst/dump_h5md.rst | 158 + doc/rst/dump_image.rst | 753 ++ doc/rst/dump_modify.rst | 1156 +++ doc/rst/dump_molfile.rst | 145 + doc/rst/dump_netcdf.rst | 97 + doc/rst/dump_vtk.rst | 199 + doc/rst/dynamical_matrix.rst | 71 + doc/rst/echo.rst | 53 + doc/rst/fix.rst | 409 + doc/rst/fix_adapt.rst | 390 + doc/rst/fix_adapt_fep.rst | 332 + doc/rst/fix_addforce.rst | 206 + doc/rst/fix_addtorque.rst | 108 + doc/rst/fix_append_atoms.rst | 128 + doc/rst/fix_atc.rst | 297 + doc/rst/fix_atom_swap.rst | 213 + doc/rst/fix_ave_atom.rst | 194 + doc/rst/fix_ave_chunk.rst | 520 + doc/rst/fix_ave_correlate.rst | 393 + doc/rst/fix_ave_correlate_long.rst | 162 + doc/rst/fix_ave_histo.rst | 395 + doc/rst/fix_ave_time.rst | 375 + doc/rst/fix_aveforce.rst | 139 + doc/rst/fix_balance.rst | 430 + doc/rst/fix_bocs.rst | 140 + doc/rst/fix_bond_break.rst | 163 + doc/rst/fix_bond_create.rst | 265 + doc/rst/fix_bond_react.rst | 487 + doc/rst/fix_bond_swap.rst | 216 + doc/rst/fix_box_relax.rst | 422 + doc/rst/fix_client_md.rst | 115 + doc/rst/fix_cmap.rst | 172 + doc/rst/fix_colvars.rst | 162 + doc/rst/fix_controller.rst | 231 + doc/rst/fix_deform.rst | 643 ++ doc/rst/fix_deposit.rst | 318 + doc/rst/fix_dpd_energy.rst | 127 + doc/rst/fix_dpd_source.rst | 124 + doc/rst/fix_drag.rst | 74 + doc/rst/fix_drude.rst | 59 + doc/rst/fix_drude_transform.rst | 231 + doc/rst/fix_dt_reset.rst | 118 + doc/rst/fix_efield.rst | 186 + doc/rst/fix_ehex.rst | 209 + doc/rst/fix_electron_stopping.rst | 210 + doc/rst/fix_enforce2d.rst | 83 + doc/rst/fix_eos_cv.rst | 79 + doc/rst/fix_eos_table.rst | 134 + doc/rst/fix_eos_table_rx.rst | 232 + doc/rst/fix_evaporate.rst | 112 + doc/rst/fix_external.rst | 187 + doc/rst/fix_ffl.rst | 142 + doc/rst/fix_filter_corotate.rst | 104 + doc/rst/fix_flow_gauss.rst | 190 + doc/rst/fix_freeze.rst | 101 + doc/rst/fix_gcmc.rst | 492 + doc/rst/fix_gld.rst | 181 + doc/rst/fix_gle.rst | 182 + doc/rst/fix_gravity.rst | 163 + doc/rst/fix_grem.rst | 131 + doc/rst/fix_halt.rst | 174 + doc/rst/fix_heat.rst | 144 + doc/rst/fix_hyper_global.rst | 301 + doc/rst/fix_hyper_local.rst | 516 + doc/rst/fix_imd.rst | 182 + doc/rst/fix_indent.rst | 234 + doc/rst/fix_ipi.rst | 117 + doc/rst/fix_langevin.rst | 370 + doc/rst/fix_langevin_drude.rst | 326 + doc/rst/fix_langevin_eff.rst | 140 + doc/rst/fix_langevin_spin.rst | 126 + doc/rst/fix_latte.rst | 259 + doc/rst/fix_lb_fluid.rst | 412 + doc/rst/fix_lb_momentum.rst | 89 + doc/rst/fix_lb_pc.rst | 73 + doc/rst/fix_lb_rigid_pc_sphere.rst | 173 + doc/rst/fix_lb_viscous.rst | 108 + doc/rst/fix_lineforce.rst | 62 + doc/rst/fix_manifoldforce.rst | 74 + doc/rst/fix_meso.rst | 61 + doc/rst/fix_meso_move.rst | 273 + doc/rst/fix_meso_stationary.rst | 62 + doc/rst/fix_modify.rst | 174 + doc/rst/fix_momentum.rst | 117 + doc/rst/fix_move.rst | 263 + doc/rst/fix_mscg.rst | 155 + doc/rst/fix_msst.rst | 228 + doc/rst/fix_mvv_dpd.rst | 119 + doc/rst/fix_neb.rst | 292 + doc/rst/fix_neb_spin.rst | 93 + doc/rst/fix_nh.rst | 743 ++ doc/rst/fix_nh_eff.rst | 181 + doc/rst/fix_nh_uef.rst | 279 + doc/rst/fix_nph_asphere.rst | 164 + doc/rst/fix_nph_body.rst | 157 + doc/rst/fix_nph_sphere.rst | 177 + doc/rst/fix_nphug.rst | 259 + doc/rst/fix_npt_asphere.rst | 189 + doc/rst/fix_npt_body.rst | 182 + doc/rst/fix_npt_sphere.rst | 201 + doc/rst/fix_nve.rst | 90 + doc/rst/fix_nve_asphere.rst | 98 + doc/rst/fix_nve_asphere_noforce.rst | 72 + doc/rst/fix_nve_awpmd.rst | 65 + doc/rst/fix_nve_body.rst | 69 + doc/rst/fix_nve_dot.rst | 88 + doc/rst/fix_nve_dotc_langevin.rst | 181 + doc/rst/fix_nve_eff.rst | 60 + doc/rst/fix_nve_limit.rst | 98 + doc/rst/fix_nve_line.rst | 65 + doc/rst/fix_nve_manifold_rattle.rst | 129 + doc/rst/fix_nve_noforce.rst | 64 + doc/rst/fix_nve_sphere.rst | 146 + doc/rst/fix_nve_spin.rst | 106 + doc/rst/fix_nve_tri.rst | 66 + doc/rst/fix_nvk.rst | 89 + doc/rst/fix_nvt_asphere.rst | 163 + doc/rst/fix_nvt_body.rst | 156 + doc/rst/fix_nvt_manifold_rattle.rst | 103 + doc/rst/fix_nvt_sllod.rst | 215 + doc/rst/fix_nvt_sllod_eff.rst | 103 + doc/rst/fix_nvt_sphere.rst | 176 + doc/rst/fix_oneway.rst | 73 + doc/rst/fix_orient.rst | 231 + doc/rst/fix_phonon.rst | 245 + doc/rst/fix_pimd.rst | 228 + doc/rst/fix_planeforce.rst | 62 + doc/rst/fix_plumed.rst | 142 + doc/rst/fix_poems.rst | 159 + doc/rst/fix_pour.rst | 291 + doc/rst/fix_precession_spin.rst | 147 + doc/rst/fix_press_berendsen.rst | 262 + doc/rst/fix_print.rst | 124 + doc/rst/fix_property_atom.rst | 343 + doc/rst/fix_python_invoke.rst | 93 + doc/rst/fix_python_move.rst | 117 + doc/rst/fix_qbmsst.rst | 256 + doc/rst/fix_qeq.rst | 270 + doc/rst/fix_qeq_comb.rst | 165 + doc/rst/fix_qeq_reax.rst | 156 + doc/rst/fix_qmmm.rst | 73 + doc/rst/fix_qtb.rst | 218 + doc/rst/fix_reaxc_bonds.rst | 122 + doc/rst/fix_reaxc_species.rst | 204 + doc/rst/fix_recenter.rst | 143 + doc/rst/fix_restrain.rst | 240 + doc/rst/fix_rhok.rst | 71 + doc/rst/fix_rigid.rst | 958 ++ doc/rst/fix_rigid_meso.rst | 396 + doc/rst/fix_rx.rst | 253 + doc/rst/fix_saed_vtk.rst | 219 + doc/rst/fix_setforce.rst | 167 + doc/rst/fix_shake.rst | 270 + doc/rst/fix_shardlow.rst | 141 + doc/rst/fix_smd.rst | 184 + doc/rst/fix_smd_adjust_dt.rst | 74 + doc/rst/fix_smd_integrate_tlsph.rst | 69 + doc/rst/fix_smd_integrate_ulsph.rst | 73 + doc/rst/fix_smd_move_triangulated_surface.rst | 93 + doc/rst/fix_smd_setvel.rst | 100 + doc/rst/fix_smd_wall_surface.rst | 86 + doc/rst/fix_spring.rst | 161 + doc/rst/fix_spring_chunk.rst | 99 + doc/rst/fix_spring_rg.rst | 85 + doc/rst/fix_spring_self.rst | 96 + doc/rst/fix_srd.rst | 432 + doc/rst/fix_store_force.rst | 81 + doc/rst/fix_store_state.rst | 148 + doc/rst/fix_temp_berendsen.rst | 186 + doc/rst/fix_temp_csvr.rst | 198 + doc/rst/fix_temp_rescale.rst | 173 + doc/rst/fix_temp_rescale_eff.rst | 83 + doc/rst/fix_tfmc.rst | 181 + doc/rst/fix_thermal_conductivity.rst | 188 + doc/rst/fix_ti_spring.rst | 189 + doc/rst/fix_tmd.rst | 151 + doc/rst/fix_ttm.rst | 383 + doc/rst/fix_tune_kspace.rst | 109 + doc/rst/fix_vector.rst | 181 + doc/rst/fix_viscosity.rst | 191 + doc/rst/fix_viscous.rst | 122 + doc/rst/fix_wall.rst | 415 + doc/rst/fix_wall_body_polygon.rst | 119 + doc/rst/fix_wall_body_polyhedron.rst | 118 + doc/rst/fix_wall_ees.rst | 145 + doc/rst/fix_wall_gran.rst | 216 + doc/rst/fix_wall_gran_region.rst | 249 + doc/rst/fix_wall_piston.rst | 135 + doc/rst/fix_wall_reflect.rst | 219 + doc/rst/fix_wall_region.rst | 232 + doc/rst/fix_wall_srd.rst | 225 + doc/rst/fixes.rst | 189 + doc/rst/group.rst | 328 + doc/rst/group2ndx.rst | 79 + doc/rst/hyper.rst | 219 + doc/rst/if.rst | 223 + doc/rst/improper_class2.rst | 148 + doc/rst/improper_coeff.rst | 110 + doc/rst/improper_cossq.rst | 102 + doc/rst/improper_cvff.rst | 105 + doc/rst/improper_distance.rst | 71 + doc/rst/improper_distharm.rst | 65 + doc/rst/improper_fourier.rst | 98 + doc/rst/improper_harmonic.rst | 111 + doc/rst/improper_hybrid.rst | 83 + doc/rst/improper_inversion_harmonic.rst | 82 + doc/rst/improper_none.rst | 46 + doc/rst/improper_ring.rst | 111 + doc/rst/improper_sqdistharm.rst | 66 + doc/rst/improper_style.rst | 128 + doc/rst/improper_umbrella.rst | 112 + doc/rst/improper_zero.rst | 58 + doc/rst/impropers.rst | 22 + doc/rst/include.rst | 52 + doc/rst/info.rst | 135 + doc/rst/jump.rst | 163 + doc/rst/kim_commands.rst | 620 ++ doc/rst/kspace_modify.rst | 567 ++ doc/rst/kspace_style.rst | 592 ++ doc/rst/label.rst | 47 + doc/rst/lattice.rst | 335 + doc/rst/log.rst | 56 + doc/rst/mass.rst | 95 + doc/rst/message.rst | 195 + doc/rst/min_modify.rst | 108 + doc/rst/min_spin.rst | 83 + doc/rst/min_style.rst | 129 + doc/rst/minimize.rst | 318 + doc/rst/molecule.rst | 518 + doc/rst/neb.rst | 478 + doc/rst/neb_spin.rst | 419 + doc/rst/neigh_modify.rst | 234 + doc/rst/neighbor.rst | 95 + doc/rst/newton.rst | 78 + doc/rst/next.rst | 163 + doc/rst/package.rst | 689 ++ doc/rst/pair_adp.rst | 211 + doc/rst/pair_agni.rst | 154 + doc/rst/pair_airebo.rst | 293 + doc/rst/pair_atm.rst | 197 + doc/rst/pair_awpmd.rst | 140 + doc/rst/pair_beck.rst | 133 + doc/rst/pair_body_nparticle.rst | 133 + doc/rst/pair_body_rounded_polygon.rst | 147 + doc/rst/pair_body_rounded_polyhedron.rst | 142 + doc/rst/pair_bop.rst | 480 + doc/rst/pair_born.rst | 238 + doc/rst/pair_brownian.rst | 161 + doc/rst/pair_buck.rst | 242 + doc/rst/pair_buck6d_coul_gauss.rst | 164 + doc/rst/pair_buck_long.rst | 199 + doc/rst/pair_charmm.rst | 336 + doc/rst/pair_class2.rst | 223 + doc/rst/pair_coeff.rst | 165 + doc/rst/pair_colloid.rst | 230 + doc/rst/pair_comb.rst | 227 + doc/rst/pair_cosine_squared.rst | 134 + doc/rst/pair_coul.rst | 434 + doc/rst/pair_coul_diel.rst | 139 + doc/rst/pair_coul_shield.rst | 119 + doc/rst/pair_cs.rst | 218 + doc/rst/pair_dipole.rst | 321 + doc/rst/pair_dpd.rst | 248 + doc/rst/pair_dpd_fdt.rst | 207 + doc/rst/pair_drip.rst | 167 + doc/rst/pair_dsmc.rst | 178 + doc/rst/pair_e3b.rst | 176 + doc/rst/pair_eam.rst | 555 ++ doc/rst/pair_edip.rst | 194 + doc/rst/pair_eff.rst | 358 + doc/rst/pair_eim.rst | 204 + doc/rst/pair_exp6_rx.rst | 214 + doc/rst/pair_extep.rst | 59 + doc/rst/pair_fep_soft.rst | 433 + doc/rst/pair_gauss.rst | 217 + doc/rst/pair_gayberne.rst | 264 + doc/rst/pair_gran.rst | 315 + doc/rst/pair_granular.rst | 876 ++ doc/rst/pair_gromacs.rst | 193 + doc/rst/pair_gw.rst | 145 + doc/rst/pair_hbond_dreiding.rst | 286 + doc/rst/pair_hybrid.rst | 444 + doc/rst/pair_ilp_graphene_hbn.rst | 197 + doc/rst/pair_kim.rst | 135 + doc/rst/pair_kolmogorov_crespi_full.rst | 166 + doc/rst/pair_kolmogorov_crespi_z.rst | 96 + doc/rst/pair_lcbop.rst | 116 + doc/rst/pair_lebedeva_z.rst | 83 + doc/rst/pair_line_lj.rst | 159 + doc/rst/pair_list.rst | 168 + doc/rst/pair_lj.rst | 448 + doc/rst/pair_lj96.rst | 126 + doc/rst/pair_lj_cubic.rst | 156 + doc/rst/pair_lj_expand.rst | 150 + doc/rst/pair_lj_long.rst | 278 + doc/rst/pair_lj_smooth.rst | 140 + doc/rst/pair_lj_smooth_linear.rst | 133 + doc/rst/pair_lj_switch3_coulgauss.rst | 104 + doc/rst/pair_lubricate.rst | 258 + doc/rst/pair_lubricateU.rst | 242 + doc/rst/pair_mdf.rst | 196 + doc/rst/pair_meam_spline.rst | 200 + doc/rst/pair_meam_sw_spline.rst | 167 + doc/rst/pair_meamc.rst | 471 + doc/rst/pair_meso.rst | 337 + doc/rst/pair_mgpt.rst | 254 + doc/rst/pair_mie.rst | 126 + doc/rst/pair_mm3_switch3_coulgauss.rst | 106 + doc/rst/pair_modify.rst | 321 + doc/rst/pair_momb.rst | 96 + doc/rst/pair_morse.rst | 170 + doc/rst/pair_multi_lucy.rst | 234 + doc/rst/pair_multi_lucy_rx.rst | 285 + doc/rst/pair_nb3b_harmonic.rst | 119 + doc/rst/pair_nm.rst | 201 + doc/rst/pair_none.rst | 58 + doc/rst/pair_oxdna.rst | 150 + doc/rst/pair_oxdna2.rst | 164 + doc/rst/pair_peri.rst | 254 + doc/rst/pair_polymorphic.rst | 288 + doc/rst/pair_python.rst | 255 + doc/rst/pair_quip.rst | 124 + doc/rst/pair_reaxc.rst | 401 + doc/rst/pair_resquared.rst | 260 + doc/rst/pair_sdk.rst | 203 + doc/rst/pair_sdpd_taitwater_isothermal.rst | 130 + doc/rst/pair_smd_hertz.rst | 73 + doc/rst/pair_smd_tlsph.rst | 89 + doc/rst/pair_smd_triangulated_surface.rst | 74 + doc/rst/pair_smd_ulsph.rst | 104 + doc/rst/pair_smtbq.rst | 300 + doc/rst/pair_snap.rst | 252 + doc/rst/pair_soft.rst | 158 + doc/rst/pair_sph_heatconduction.rst | 74 + doc/rst/pair_sph_idealgas.rst | 93 + doc/rst/pair_sph_lj.rst | 98 + doc/rst/pair_sph_rhosum.rst | 75 + doc/rst/pair_sph_taitwater.rst | 96 + doc/rst/pair_sph_taitwater_morris.rst | 94 + doc/rst/pair_spin_dipole.rst | 97 + doc/rst/pair_spin_dmi.rst | 113 + doc/rst/pair_spin_exchange.rst | 118 + doc/rst/pair_spin_magelec.rst | 95 + doc/rst/pair_spin_neel.rst | 103 + doc/rst/pair_srp.rst | 190 + doc/rst/pair_style.rst | 355 + doc/rst/pair_sw.rst | 246 + doc/rst/pair_table.rst | 301 + doc/rst/pair_table_rx.rst | 288 + doc/rst/pair_tersoff.rst | 294 + doc/rst/pair_tersoff_mod.rst | 252 + doc/rst/pair_tersoff_zbl.rst | 306 + doc/rst/pair_thole.rst | 220 + doc/rst/pair_tri_lj.rst | 128 + doc/rst/pair_ufm.rst | 167 + doc/rst/pair_vashishta.rst | 289 + doc/rst/pair_write.rst | 91 + doc/rst/pair_yukawa.rst | 126 + doc/rst/pair_yukawa_colloid.rst | 181 + doc/rst/pair_zbl.rst | 169 + doc/rst/pair_zero.rst | 100 + doc/rst/pairs.rst | 129 + doc/rst/partition.rst | 82 + doc/rst/prd.rst | 371 + doc/rst/print.rst | 101 + doc/rst/processors.rst | 385 + doc/rst/python.rst | 556 ++ doc/rst/quit.rst | 58 + doc/rst/read_data.rst | 1445 +++ doc/rst/read_dump.rst | 380 + doc/rst/read_restart.rst | 288 + doc/rst/region.rst | 435 + doc/rst/replicate.rst | 116 + doc/rst/rerun.rst | 237 + doc/rst/reset_ids.rst | 69 + doc/rst/reset_timestep.rst | 72 + doc/rst/restart.rst | 204 + doc/rst/run.rst | 241 + doc/rst/run_style.rst | 374 + doc/rst/server.rst | 81 + doc/rst/server_mc.rst | 137 + doc/rst/server_md.rst | 174 + doc/rst/set.rst | 491 + doc/rst/shell.rst | 128 + doc/rst/special_bonds.rst | 300 + doc/rst/suffix.rst | 117 + doc/rst/tad.rst | 339 + doc/rst/temper.rst | 176 + doc/rst/temper_grem.rst | 133 + doc/rst/temper_npt.rst | 88 + doc/rst/thermo.rst | 76 + doc/rst/thermo_modify.rst | 200 + doc/rst/thermo_style.rst | 451 + doc/rst/timer.rst | 140 + doc/rst/timestep.rst | 74 + doc/rst/uncompute.rst | 46 + doc/rst/undump.rst | 45 + doc/rst/unfix.rst | 46 + doc/rst/units.rst | 238 + doc/rst/variable.rst | 1481 +++ doc/rst/velocity.rst | 288 + doc/rst/write_coeff.rst | 58 + doc/rst/write_data.rst | 152 + doc/rst/write_dump.rst | 105 + doc/rst/write_restart.rst | 144 + 755 files changed, 141591 insertions(+), 8 deletions(-) create mode 100644 doc/rst/.gitignore create mode 100644 doc/rst/Build.rst create mode 100644 doc/rst/Build_basics.rst create mode 100644 doc/rst/Build_cmake.rst create mode 100644 doc/rst/Build_development.rst create mode 100644 doc/rst/Build_extras.rst create mode 100644 doc/rst/Build_link.rst create mode 100644 doc/rst/Build_make.rst create mode 100644 doc/rst/Build_package.rst create mode 100644 doc/rst/Build_settings.rst create mode 100644 doc/rst/Build_windows.rst create mode 100644 doc/rst/Commands.rst create mode 100644 doc/rst/Commands_all.rst create mode 100644 doc/rst/Commands_bond.rst create mode 100644 doc/rst/Commands_category.rst create mode 100644 doc/rst/Commands_compute.rst create mode 100644 doc/rst/Commands_fix.rst create mode 100644 doc/rst/Commands_input.rst create mode 100644 doc/rst/Commands_kspace.rst create mode 100644 doc/rst/Commands_pair.rst create mode 100644 doc/rst/Commands_parse.rst create mode 100644 doc/rst/Commands_removed.rst create mode 100644 doc/rst/Commands_structure.rst create mode 100644 doc/rst/Errors.rst create mode 100644 doc/rst/Errors_bugs.rst create mode 100644 doc/rst/Errors_common.rst create mode 100644 doc/rst/Errors_messages.rst create mode 100644 doc/rst/Errors_warnings.rst create mode 100644 doc/rst/Examples.rst create mode 100644 doc/rst/Howto.rst create mode 100644 doc/rst/Howto_2d.rst create mode 100644 doc/rst/Howto_barostat.rst create mode 100644 doc/rst/Howto_bash.rst create mode 100644 doc/rst/Howto_bioFF.rst create mode 100644 doc/rst/Howto_body.rst create mode 100644 doc/rst/Howto_chunk.rst create mode 100644 doc/rst/Howto_client_server.rst create mode 100644 doc/rst/Howto_coreshell.rst create mode 100644 doc/rst/Howto_couple.rst create mode 100644 doc/rst/Howto_diffusion.rst create mode 100644 doc/rst/Howto_dispersion.rst create mode 100644 doc/rst/Howto_drude.rst create mode 100644 doc/rst/Howto_drude2.rst create mode 100644 doc/rst/Howto_elastic.rst create mode 100644 doc/rst/Howto_github.rst create mode 100644 doc/rst/Howto_granular.rst create mode 100644 doc/rst/Howto_kappa.rst create mode 100644 doc/rst/Howto_library.rst create mode 100644 doc/rst/Howto_manifold.rst create mode 100644 doc/rst/Howto_multiple.rst create mode 100644 doc/rst/Howto_nemd.rst create mode 100644 doc/rst/Howto_output.rst create mode 100644 doc/rst/Howto_polarizable.rst create mode 100644 doc/rst/Howto_pylammps.rst create mode 100644 doc/rst/Howto_replica.rst create mode 100644 doc/rst/Howto_restart.rst create mode 100644 doc/rst/Howto_spc.rst create mode 100644 doc/rst/Howto_spherical.rst create mode 100644 doc/rst/Howto_spins.rst create mode 100644 doc/rst/Howto_temperature.rst create mode 100644 doc/rst/Howto_thermostat.rst create mode 100644 doc/rst/Howto_tip3p.rst create mode 100644 doc/rst/Howto_tip4p.rst create mode 100644 doc/rst/Howto_triclinic.rst create mode 100644 doc/rst/Howto_viscosity.rst create mode 100644 doc/rst/Howto_viz.rst create mode 100644 doc/rst/Howto_walls.rst create mode 100644 doc/rst/Install.rst create mode 100644 doc/rst/Install_git.rst create mode 100644 doc/rst/Install_linux.rst create mode 100644 doc/rst/Install_mac.rst create mode 100644 doc/rst/Install_patch.rst create mode 100644 doc/rst/Install_svn.rst create mode 100644 doc/rst/Install_tarball.rst create mode 100644 doc/rst/Install_windows.rst create mode 100644 doc/rst/Intro.rst create mode 100644 doc/rst/Intro_authors.rst create mode 100644 doc/rst/Intro_features.rst create mode 100644 doc/rst/Intro_nonfeatures.rst create mode 100644 doc/rst/Intro_opensource.rst create mode 100644 doc/rst/Intro_overview.rst create mode 100644 doc/rst/Intro_website.rst create mode 100644 doc/rst/Manual.rst create mode 100644 doc/rst/Manual_build.rst create mode 100644 doc/rst/Manual_version.rst create mode 100644 doc/rst/Modify.rst create mode 100644 doc/rst/Modify_atom.rst create mode 100644 doc/rst/Modify_body.rst create mode 100644 doc/rst/Modify_bond.rst create mode 100644 doc/rst/Modify_command.rst create mode 100644 doc/rst/Modify_compute.rst create mode 100644 doc/rst/Modify_contribute.rst create mode 100644 doc/rst/Modify_dump.rst create mode 100644 doc/rst/Modify_fix.rst create mode 100644 doc/rst/Modify_kspace.rst create mode 100644 doc/rst/Modify_min.rst create mode 100644 doc/rst/Modify_overview.rst create mode 100644 doc/rst/Modify_pair.rst create mode 100644 doc/rst/Modify_region.rst create mode 100644 doc/rst/Modify_thermo.rst create mode 100644 doc/rst/Modify_variable.rst create mode 100644 doc/rst/Packages.rst create mode 100644 doc/rst/Packages_details.rst create mode 100644 doc/rst/Packages_standard.rst create mode 100644 doc/rst/Packages_user.rst create mode 100644 doc/rst/Python_call.rst create mode 100644 doc/rst/Python_examples.rst create mode 100644 doc/rst/Python_head.rst create mode 100644 doc/rst/Python_install.rst create mode 100644 doc/rst/Python_library.rst create mode 100644 doc/rst/Python_mpi.rst create mode 100644 doc/rst/Python_overview.rst create mode 100644 doc/rst/Python_pylammps.rst create mode 100644 doc/rst/Python_run.rst create mode 100644 doc/rst/Python_shlib.rst create mode 100644 doc/rst/Python_test.rst create mode 100644 doc/rst/Run_basics.rst create mode 100644 doc/rst/Run_head.rst create mode 100644 doc/rst/Run_options.rst create mode 100644 doc/rst/Run_output.rst create mode 100644 doc/rst/Run_windows.rst create mode 100644 doc/rst/Speed.rst create mode 100644 doc/rst/Speed_bench.rst create mode 100644 doc/rst/Speed_compare.rst create mode 100644 doc/rst/Speed_gpu.rst create mode 100644 doc/rst/Speed_intel.rst create mode 100644 doc/rst/Speed_kokkos.rst create mode 100644 doc/rst/Speed_measure.rst create mode 100644 doc/rst/Speed_omp.rst create mode 100644 doc/rst/Speed_opt.rst create mode 100644 doc/rst/Speed_packages.rst create mode 100644 doc/rst/Speed_tips.rst create mode 100644 doc/rst/Tools.rst create mode 100644 doc/rst/angle_charmm.rst create mode 100644 doc/rst/angle_class2.rst create mode 100644 doc/rst/angle_coeff.rst create mode 100644 doc/rst/angle_cosine.rst create mode 100644 doc/rst/angle_cosine_buck6d.rst create mode 100644 doc/rst/angle_cosine_delta.rst create mode 100644 doc/rst/angle_cosine_periodic.rst create mode 100644 doc/rst/angle_cosine_shift.rst create mode 100644 doc/rst/angle_cosine_shift_exp.rst create mode 100644 doc/rst/angle_cosine_squared.rst create mode 100644 doc/rst/angle_cross.rst create mode 100644 doc/rst/angle_dipole.rst create mode 100644 doc/rst/angle_fourier.rst create mode 100644 doc/rst/angle_fourier_simple.rst create mode 100644 doc/rst/angle_harmonic.rst create mode 100644 doc/rst/angle_hybrid.rst create mode 100644 doc/rst/angle_mm3.rst create mode 100644 doc/rst/angle_none.rst create mode 100644 doc/rst/angle_quartic.rst create mode 100644 doc/rst/angle_sdk.rst create mode 100644 doc/rst/angle_style.rst create mode 100644 doc/rst/angle_table.rst create mode 100644 doc/rst/angle_zero.rst create mode 100644 doc/rst/angles.rst create mode 100644 doc/rst/atom_modify.rst create mode 100644 doc/rst/atom_style.rst create mode 100644 doc/rst/balance.rst create mode 100644 doc/rst/bond_class2.rst create mode 100644 doc/rst/bond_coeff.rst create mode 100644 doc/rst/bond_fene.rst create mode 100644 doc/rst/bond_fene_expand.rst create mode 100644 doc/rst/bond_gromos.rst create mode 100644 doc/rst/bond_harmonic.rst create mode 100644 doc/rst/bond_harmonic_shift.rst create mode 100644 doc/rst/bond_harmonic_shift_cut.rst create mode 100644 doc/rst/bond_hybrid.rst create mode 100644 doc/rst/bond_mm3.rst create mode 100644 doc/rst/bond_morse.rst create mode 100644 doc/rst/bond_none.rst create mode 100644 doc/rst/bond_nonlinear.rst create mode 100644 doc/rst/bond_oxdna.rst create mode 100644 doc/rst/bond_quartic.rst create mode 100644 doc/rst/bond_style.rst create mode 100644 doc/rst/bond_table.rst create mode 100644 doc/rst/bond_write.rst create mode 100644 doc/rst/bond_zero.rst create mode 100644 doc/rst/bonds.rst create mode 100644 doc/rst/boundary.rst create mode 100644 doc/rst/box.rst create mode 100644 doc/rst/change_box.rst create mode 100644 doc/rst/clear.rst create mode 100644 doc/rst/comm_modify.rst create mode 100644 doc/rst/comm_style.rst create mode 100644 doc/rst/commands_list.rst create mode 100644 doc/rst/compute.rst create mode 100644 doc/rst/compute_ackland_atom.rst create mode 100644 doc/rst/compute_adf.rst create mode 100644 doc/rst/compute_angle.rst create mode 100644 doc/rst/compute_angle_local.rst create mode 100644 doc/rst/compute_angmom_chunk.rst create mode 100644 doc/rst/compute_basal_atom.rst create mode 100644 doc/rst/compute_body_local.rst create mode 100644 doc/rst/compute_bond.rst create mode 100644 doc/rst/compute_bond_local.rst create mode 100644 doc/rst/compute_centro_atom.rst create mode 100644 doc/rst/compute_chunk_atom.rst create mode 100644 doc/rst/compute_chunk_spread_atom.rst create mode 100644 doc/rst/compute_cluster_atom.rst create mode 100644 doc/rst/compute_cna_atom.rst create mode 100644 doc/rst/compute_cnp_atom.rst create mode 100644 doc/rst/compute_com.rst create mode 100644 doc/rst/compute_com_chunk.rst create mode 100644 doc/rst/compute_contact_atom.rst create mode 100644 doc/rst/compute_coord_atom.rst create mode 100644 doc/rst/compute_damage_atom.rst create mode 100644 doc/rst/compute_dihedral.rst create mode 100644 doc/rst/compute_dihedral_local.rst create mode 100644 doc/rst/compute_dilatation_atom.rst create mode 100644 doc/rst/compute_dipole_chunk.rst create mode 100644 doc/rst/compute_displace_atom.rst create mode 100644 doc/rst/compute_dpd.rst create mode 100644 doc/rst/compute_dpd_atom.rst create mode 100644 doc/rst/compute_edpd_temp_atom.rst create mode 100644 doc/rst/compute_entropy_atom.rst create mode 100644 doc/rst/compute_erotate_asphere.rst create mode 100644 doc/rst/compute_erotate_rigid.rst create mode 100644 doc/rst/compute_erotate_sphere.rst create mode 100644 doc/rst/compute_erotate_sphere_atom.rst create mode 100644 doc/rst/compute_event_displace.rst create mode 100644 doc/rst/compute_fep.rst create mode 100644 doc/rst/compute_global_atom.rst create mode 100644 doc/rst/compute_group_group.rst create mode 100644 doc/rst/compute_gyration.rst create mode 100644 doc/rst/compute_gyration_chunk.rst create mode 100644 doc/rst/compute_gyration_shape.rst create mode 100644 doc/rst/compute_heat_flux.rst create mode 100644 doc/rst/compute_hexorder_atom.rst create mode 100644 doc/rst/compute_hma.rst create mode 100644 doc/rst/compute_improper.rst create mode 100644 doc/rst/compute_improper_local.rst create mode 100644 doc/rst/compute_inertia_chunk.rst create mode 100644 doc/rst/compute_ke.rst create mode 100644 doc/rst/compute_ke_atom.rst create mode 100644 doc/rst/compute_ke_atom_eff.rst create mode 100644 doc/rst/compute_ke_eff.rst create mode 100644 doc/rst/compute_ke_rigid.rst create mode 100644 doc/rst/compute_meso_e_atom.rst create mode 100644 doc/rst/compute_meso_rho_atom.rst create mode 100644 doc/rst/compute_meso_t_atom.rst create mode 100644 doc/rst/compute_modify.rst create mode 100644 doc/rst/compute_momentum.rst create mode 100644 doc/rst/compute_msd.rst create mode 100644 doc/rst/compute_msd_chunk.rst create mode 100644 doc/rst/compute_msd_nongauss.rst create mode 100644 doc/rst/compute_omega_chunk.rst create mode 100644 doc/rst/compute_orientorder_atom.rst create mode 100644 doc/rst/compute_pair.rst create mode 100644 doc/rst/compute_pair_local.rst create mode 100644 doc/rst/compute_pe.rst create mode 100644 doc/rst/compute_pe_atom.rst create mode 100644 doc/rst/compute_plasticity_atom.rst create mode 100644 doc/rst/compute_pressure.rst create mode 100644 doc/rst/compute_pressure_cylinder.rst create mode 100644 doc/rst/compute_pressure_uef.rst create mode 100644 doc/rst/compute_property_atom.rst create mode 100644 doc/rst/compute_property_chunk.rst create mode 100644 doc/rst/compute_property_local.rst create mode 100644 doc/rst/compute_ptm_atom.rst create mode 100644 doc/rst/compute_rdf.rst create mode 100644 doc/rst/compute_reduce.rst create mode 100644 doc/rst/compute_reduce_chunk.rst create mode 100644 doc/rst/compute_rigid_local.rst create mode 100644 doc/rst/compute_saed.rst create mode 100644 doc/rst/compute_slice.rst create mode 100644 doc/rst/compute_smd_contact_radius.rst create mode 100644 doc/rst/compute_smd_damage.rst create mode 100644 doc/rst/compute_smd_hourglass_error.rst create mode 100644 doc/rst/compute_smd_internal_energy.rst create mode 100644 doc/rst/compute_smd_plastic_strain.rst create mode 100644 doc/rst/compute_smd_plastic_strain_rate.rst create mode 100644 doc/rst/compute_smd_rho.rst create mode 100644 doc/rst/compute_smd_tlsph_defgrad.rst create mode 100644 doc/rst/compute_smd_tlsph_dt.rst create mode 100644 doc/rst/compute_smd_tlsph_num_neighs.rst create mode 100644 doc/rst/compute_smd_tlsph_shape.rst create mode 100644 doc/rst/compute_smd_tlsph_strain.rst create mode 100644 doc/rst/compute_smd_tlsph_strain_rate.rst create mode 100644 doc/rst/compute_smd_tlsph_stress.rst create mode 100644 doc/rst/compute_smd_triangle_vertices.rst create mode 100644 doc/rst/compute_smd_ulsph_num_neighs.rst create mode 100644 doc/rst/compute_smd_ulsph_strain.rst create mode 100644 doc/rst/compute_smd_ulsph_strain_rate.rst create mode 100644 doc/rst/compute_smd_ulsph_stress.rst create mode 100644 doc/rst/compute_smd_vol.rst create mode 100644 doc/rst/compute_sna_atom.rst create mode 100644 doc/rst/compute_spin.rst create mode 100644 doc/rst/compute_stress_atom.rst create mode 100644 doc/rst/compute_stress_mop.rst create mode 100644 doc/rst/compute_tally.rst create mode 100644 doc/rst/compute_tdpd_cc_atom.rst create mode 100644 doc/rst/compute_temp.rst create mode 100644 doc/rst/compute_temp_asphere.rst create mode 100644 doc/rst/compute_temp_body.rst create mode 100644 doc/rst/compute_temp_chunk.rst create mode 100644 doc/rst/compute_temp_com.rst create mode 100644 doc/rst/compute_temp_cs.rst create mode 100644 doc/rst/compute_temp_deform.rst create mode 100644 doc/rst/compute_temp_deform_eff.rst create mode 100644 doc/rst/compute_temp_drude.rst create mode 100644 doc/rst/compute_temp_eff.rst create mode 100644 doc/rst/compute_temp_partial.rst create mode 100644 doc/rst/compute_temp_profile.rst create mode 100644 doc/rst/compute_temp_ramp.rst create mode 100644 doc/rst/compute_temp_region.rst create mode 100644 doc/rst/compute_temp_region_eff.rst create mode 100644 doc/rst/compute_temp_rotate.rst create mode 100644 doc/rst/compute_temp_sphere.rst create mode 100644 doc/rst/compute_temp_uef.rst create mode 100644 doc/rst/compute_ti.rst create mode 100644 doc/rst/compute_torque_chunk.rst create mode 100644 doc/rst/compute_vacf.rst create mode 100644 doc/rst/compute_vcm_chunk.rst create mode 100644 doc/rst/compute_voronoi_atom.rst create mode 100644 doc/rst/compute_xrd.rst create mode 100644 doc/rst/computes.rst create mode 100644 doc/rst/create_atoms.rst create mode 100644 doc/rst/create_bonds.rst create mode 100644 doc/rst/create_box.rst create mode 100644 doc/rst/delete_atoms.rst create mode 100644 doc/rst/delete_bonds.rst create mode 100644 doc/rst/dielectric.rst create mode 100644 doc/rst/dihedral_charmm.rst create mode 100644 doc/rst/dihedral_class2.rst create mode 100644 doc/rst/dihedral_coeff.rst create mode 100644 doc/rst/dihedral_cosine_shift_exp.rst create mode 100644 doc/rst/dihedral_fourier.rst create mode 100644 doc/rst/dihedral_harmonic.rst create mode 100644 doc/rst/dihedral_helix.rst create mode 100644 doc/rst/dihedral_hybrid.rst create mode 100644 doc/rst/dihedral_multi_harmonic.rst create mode 100644 doc/rst/dihedral_nharmonic.rst create mode 100644 doc/rst/dihedral_none.rst create mode 100644 doc/rst/dihedral_opls.rst create mode 100644 doc/rst/dihedral_quadratic.rst create mode 100644 doc/rst/dihedral_spherical.rst create mode 100644 doc/rst/dihedral_style.rst create mode 100644 doc/rst/dihedral_table.rst create mode 100644 doc/rst/dihedral_table_cut.rst create mode 100644 doc/rst/dihedral_zero.rst create mode 100644 doc/rst/dihedrals.rst create mode 100644 doc/rst/dimension.rst create mode 100644 doc/rst/displace_atoms.rst create mode 100644 doc/rst/dump.rst create mode 100644 doc/rst/dump_adios.rst create mode 100644 doc/rst/dump_cfg_uef.rst create mode 100644 doc/rst/dump_h5md.rst create mode 100644 doc/rst/dump_image.rst create mode 100644 doc/rst/dump_modify.rst create mode 100644 doc/rst/dump_molfile.rst create mode 100644 doc/rst/dump_netcdf.rst create mode 100644 doc/rst/dump_vtk.rst create mode 100644 doc/rst/dynamical_matrix.rst create mode 100644 doc/rst/echo.rst create mode 100644 doc/rst/fix.rst create mode 100644 doc/rst/fix_adapt.rst create mode 100644 doc/rst/fix_adapt_fep.rst create mode 100644 doc/rst/fix_addforce.rst create mode 100644 doc/rst/fix_addtorque.rst create mode 100644 doc/rst/fix_append_atoms.rst create mode 100644 doc/rst/fix_atc.rst create mode 100644 doc/rst/fix_atom_swap.rst create mode 100644 doc/rst/fix_ave_atom.rst create mode 100644 doc/rst/fix_ave_chunk.rst create mode 100644 doc/rst/fix_ave_correlate.rst create mode 100644 doc/rst/fix_ave_correlate_long.rst create mode 100644 doc/rst/fix_ave_histo.rst create mode 100644 doc/rst/fix_ave_time.rst create mode 100644 doc/rst/fix_aveforce.rst create mode 100644 doc/rst/fix_balance.rst create mode 100644 doc/rst/fix_bocs.rst create mode 100644 doc/rst/fix_bond_break.rst create mode 100644 doc/rst/fix_bond_create.rst create mode 100644 doc/rst/fix_bond_react.rst create mode 100644 doc/rst/fix_bond_swap.rst create mode 100644 doc/rst/fix_box_relax.rst create mode 100644 doc/rst/fix_client_md.rst create mode 100644 doc/rst/fix_cmap.rst create mode 100644 doc/rst/fix_colvars.rst create mode 100644 doc/rst/fix_controller.rst create mode 100644 doc/rst/fix_deform.rst create mode 100644 doc/rst/fix_deposit.rst create mode 100644 doc/rst/fix_dpd_energy.rst create mode 100644 doc/rst/fix_dpd_source.rst create mode 100644 doc/rst/fix_drag.rst create mode 100644 doc/rst/fix_drude.rst create mode 100644 doc/rst/fix_drude_transform.rst create mode 100644 doc/rst/fix_dt_reset.rst create mode 100644 doc/rst/fix_efield.rst create mode 100644 doc/rst/fix_ehex.rst create mode 100644 doc/rst/fix_electron_stopping.rst create mode 100644 doc/rst/fix_enforce2d.rst create mode 100644 doc/rst/fix_eos_cv.rst create mode 100644 doc/rst/fix_eos_table.rst create mode 100644 doc/rst/fix_eos_table_rx.rst create mode 100644 doc/rst/fix_evaporate.rst create mode 100644 doc/rst/fix_external.rst create mode 100644 doc/rst/fix_ffl.rst create mode 100644 doc/rst/fix_filter_corotate.rst create mode 100644 doc/rst/fix_flow_gauss.rst create mode 100644 doc/rst/fix_freeze.rst create mode 100644 doc/rst/fix_gcmc.rst create mode 100644 doc/rst/fix_gld.rst create mode 100644 doc/rst/fix_gle.rst create mode 100644 doc/rst/fix_gravity.rst create mode 100644 doc/rst/fix_grem.rst create mode 100644 doc/rst/fix_halt.rst create mode 100644 doc/rst/fix_heat.rst create mode 100644 doc/rst/fix_hyper_global.rst create mode 100644 doc/rst/fix_hyper_local.rst create mode 100644 doc/rst/fix_imd.rst create mode 100644 doc/rst/fix_indent.rst create mode 100644 doc/rst/fix_ipi.rst create mode 100644 doc/rst/fix_langevin.rst create mode 100644 doc/rst/fix_langevin_drude.rst create mode 100644 doc/rst/fix_langevin_eff.rst create mode 100644 doc/rst/fix_langevin_spin.rst create mode 100644 doc/rst/fix_latte.rst create mode 100644 doc/rst/fix_lb_fluid.rst create mode 100644 doc/rst/fix_lb_momentum.rst create mode 100644 doc/rst/fix_lb_pc.rst create mode 100644 doc/rst/fix_lb_rigid_pc_sphere.rst create mode 100644 doc/rst/fix_lb_viscous.rst create mode 100644 doc/rst/fix_lineforce.rst create mode 100644 doc/rst/fix_manifoldforce.rst create mode 100644 doc/rst/fix_meso.rst create mode 100644 doc/rst/fix_meso_move.rst create mode 100644 doc/rst/fix_meso_stationary.rst create mode 100644 doc/rst/fix_modify.rst create mode 100644 doc/rst/fix_momentum.rst create mode 100644 doc/rst/fix_move.rst create mode 100644 doc/rst/fix_mscg.rst create mode 100644 doc/rst/fix_msst.rst create mode 100644 doc/rst/fix_mvv_dpd.rst create mode 100644 doc/rst/fix_neb.rst create mode 100644 doc/rst/fix_neb_spin.rst create mode 100644 doc/rst/fix_nh.rst create mode 100644 doc/rst/fix_nh_eff.rst create mode 100644 doc/rst/fix_nh_uef.rst create mode 100644 doc/rst/fix_nph_asphere.rst create mode 100644 doc/rst/fix_nph_body.rst create mode 100644 doc/rst/fix_nph_sphere.rst create mode 100644 doc/rst/fix_nphug.rst create mode 100644 doc/rst/fix_npt_asphere.rst create mode 100644 doc/rst/fix_npt_body.rst create mode 100644 doc/rst/fix_npt_sphere.rst create mode 100644 doc/rst/fix_nve.rst create mode 100644 doc/rst/fix_nve_asphere.rst create mode 100644 doc/rst/fix_nve_asphere_noforce.rst create mode 100644 doc/rst/fix_nve_awpmd.rst create mode 100644 doc/rst/fix_nve_body.rst create mode 100644 doc/rst/fix_nve_dot.rst create mode 100644 doc/rst/fix_nve_dotc_langevin.rst create mode 100644 doc/rst/fix_nve_eff.rst create mode 100644 doc/rst/fix_nve_limit.rst create mode 100644 doc/rst/fix_nve_line.rst create mode 100644 doc/rst/fix_nve_manifold_rattle.rst create mode 100644 doc/rst/fix_nve_noforce.rst create mode 100644 doc/rst/fix_nve_sphere.rst create mode 100644 doc/rst/fix_nve_spin.rst create mode 100644 doc/rst/fix_nve_tri.rst create mode 100644 doc/rst/fix_nvk.rst create mode 100644 doc/rst/fix_nvt_asphere.rst create mode 100644 doc/rst/fix_nvt_body.rst create mode 100644 doc/rst/fix_nvt_manifold_rattle.rst create mode 100644 doc/rst/fix_nvt_sllod.rst create mode 100644 doc/rst/fix_nvt_sllod_eff.rst create mode 100644 doc/rst/fix_nvt_sphere.rst create mode 100644 doc/rst/fix_oneway.rst create mode 100644 doc/rst/fix_orient.rst create mode 100644 doc/rst/fix_phonon.rst create mode 100644 doc/rst/fix_pimd.rst create mode 100644 doc/rst/fix_planeforce.rst create mode 100644 doc/rst/fix_plumed.rst create mode 100644 doc/rst/fix_poems.rst create mode 100644 doc/rst/fix_pour.rst create mode 100644 doc/rst/fix_precession_spin.rst create mode 100644 doc/rst/fix_press_berendsen.rst create mode 100644 doc/rst/fix_print.rst create mode 100644 doc/rst/fix_property_atom.rst create mode 100644 doc/rst/fix_python_invoke.rst create mode 100644 doc/rst/fix_python_move.rst create mode 100644 doc/rst/fix_qbmsst.rst create mode 100644 doc/rst/fix_qeq.rst create mode 100644 doc/rst/fix_qeq_comb.rst create mode 100644 doc/rst/fix_qeq_reax.rst create mode 100644 doc/rst/fix_qmmm.rst create mode 100644 doc/rst/fix_qtb.rst create mode 100644 doc/rst/fix_reaxc_bonds.rst create mode 100644 doc/rst/fix_reaxc_species.rst create mode 100644 doc/rst/fix_recenter.rst create mode 100644 doc/rst/fix_restrain.rst create mode 100644 doc/rst/fix_rhok.rst create mode 100644 doc/rst/fix_rigid.rst create mode 100644 doc/rst/fix_rigid_meso.rst create mode 100644 doc/rst/fix_rx.rst create mode 100644 doc/rst/fix_saed_vtk.rst create mode 100644 doc/rst/fix_setforce.rst create mode 100644 doc/rst/fix_shake.rst create mode 100644 doc/rst/fix_shardlow.rst create mode 100644 doc/rst/fix_smd.rst create mode 100644 doc/rst/fix_smd_adjust_dt.rst create mode 100644 doc/rst/fix_smd_integrate_tlsph.rst create mode 100644 doc/rst/fix_smd_integrate_ulsph.rst create mode 100644 doc/rst/fix_smd_move_triangulated_surface.rst create mode 100644 doc/rst/fix_smd_setvel.rst create mode 100644 doc/rst/fix_smd_wall_surface.rst create mode 100644 doc/rst/fix_spring.rst create mode 100644 doc/rst/fix_spring_chunk.rst create mode 100644 doc/rst/fix_spring_rg.rst create mode 100644 doc/rst/fix_spring_self.rst create mode 100644 doc/rst/fix_srd.rst create mode 100644 doc/rst/fix_store_force.rst create mode 100644 doc/rst/fix_store_state.rst create mode 100644 doc/rst/fix_temp_berendsen.rst create mode 100644 doc/rst/fix_temp_csvr.rst create mode 100644 doc/rst/fix_temp_rescale.rst create mode 100644 doc/rst/fix_temp_rescale_eff.rst create mode 100644 doc/rst/fix_tfmc.rst create mode 100644 doc/rst/fix_thermal_conductivity.rst create mode 100644 doc/rst/fix_ti_spring.rst create mode 100644 doc/rst/fix_tmd.rst create mode 100644 doc/rst/fix_ttm.rst create mode 100644 doc/rst/fix_tune_kspace.rst create mode 100644 doc/rst/fix_vector.rst create mode 100644 doc/rst/fix_viscosity.rst create mode 100644 doc/rst/fix_viscous.rst create mode 100644 doc/rst/fix_wall.rst create mode 100644 doc/rst/fix_wall_body_polygon.rst create mode 100644 doc/rst/fix_wall_body_polyhedron.rst create mode 100644 doc/rst/fix_wall_ees.rst create mode 100644 doc/rst/fix_wall_gran.rst create mode 100644 doc/rst/fix_wall_gran_region.rst create mode 100644 doc/rst/fix_wall_piston.rst create mode 100644 doc/rst/fix_wall_reflect.rst create mode 100644 doc/rst/fix_wall_region.rst create mode 100644 doc/rst/fix_wall_srd.rst create mode 100644 doc/rst/fixes.rst create mode 100644 doc/rst/group.rst create mode 100644 doc/rst/group2ndx.rst create mode 100644 doc/rst/hyper.rst create mode 100644 doc/rst/if.rst create mode 100644 doc/rst/improper_class2.rst create mode 100644 doc/rst/improper_coeff.rst create mode 100644 doc/rst/improper_cossq.rst create mode 100644 doc/rst/improper_cvff.rst create mode 100644 doc/rst/improper_distance.rst create mode 100644 doc/rst/improper_distharm.rst create mode 100644 doc/rst/improper_fourier.rst create mode 100644 doc/rst/improper_harmonic.rst create mode 100644 doc/rst/improper_hybrid.rst create mode 100644 doc/rst/improper_inversion_harmonic.rst create mode 100644 doc/rst/improper_none.rst create mode 100644 doc/rst/improper_ring.rst create mode 100644 doc/rst/improper_sqdistharm.rst create mode 100644 doc/rst/improper_style.rst create mode 100644 doc/rst/improper_umbrella.rst create mode 100644 doc/rst/improper_zero.rst create mode 100644 doc/rst/impropers.rst create mode 100644 doc/rst/include.rst create mode 100644 doc/rst/info.rst create mode 100644 doc/rst/jump.rst create mode 100644 doc/rst/kim_commands.rst create mode 100644 doc/rst/kspace_modify.rst create mode 100644 doc/rst/kspace_style.rst create mode 100644 doc/rst/label.rst create mode 100644 doc/rst/lattice.rst create mode 100644 doc/rst/log.rst create mode 100644 doc/rst/mass.rst create mode 100644 doc/rst/message.rst create mode 100644 doc/rst/min_modify.rst create mode 100644 doc/rst/min_spin.rst create mode 100644 doc/rst/min_style.rst create mode 100644 doc/rst/minimize.rst create mode 100644 doc/rst/molecule.rst create mode 100644 doc/rst/neb.rst create mode 100644 doc/rst/neb_spin.rst create mode 100644 doc/rst/neigh_modify.rst create mode 100644 doc/rst/neighbor.rst create mode 100644 doc/rst/newton.rst create mode 100644 doc/rst/next.rst create mode 100644 doc/rst/package.rst create mode 100644 doc/rst/pair_adp.rst create mode 100644 doc/rst/pair_agni.rst create mode 100644 doc/rst/pair_airebo.rst create mode 100644 doc/rst/pair_atm.rst create mode 100644 doc/rst/pair_awpmd.rst create mode 100644 doc/rst/pair_beck.rst create mode 100644 doc/rst/pair_body_nparticle.rst create mode 100644 doc/rst/pair_body_rounded_polygon.rst create mode 100644 doc/rst/pair_body_rounded_polyhedron.rst create mode 100644 doc/rst/pair_bop.rst create mode 100644 doc/rst/pair_born.rst create mode 100644 doc/rst/pair_brownian.rst create mode 100644 doc/rst/pair_buck.rst create mode 100644 doc/rst/pair_buck6d_coul_gauss.rst create mode 100644 doc/rst/pair_buck_long.rst create mode 100644 doc/rst/pair_charmm.rst create mode 100644 doc/rst/pair_class2.rst create mode 100644 doc/rst/pair_coeff.rst create mode 100644 doc/rst/pair_colloid.rst create mode 100644 doc/rst/pair_comb.rst create mode 100644 doc/rst/pair_cosine_squared.rst create mode 100644 doc/rst/pair_coul.rst create mode 100644 doc/rst/pair_coul_diel.rst create mode 100644 doc/rst/pair_coul_shield.rst create mode 100644 doc/rst/pair_cs.rst create mode 100644 doc/rst/pair_dipole.rst create mode 100644 doc/rst/pair_dpd.rst create mode 100644 doc/rst/pair_dpd_fdt.rst create mode 100644 doc/rst/pair_drip.rst create mode 100644 doc/rst/pair_dsmc.rst create mode 100644 doc/rst/pair_e3b.rst create mode 100644 doc/rst/pair_eam.rst create mode 100644 doc/rst/pair_edip.rst create mode 100644 doc/rst/pair_eff.rst create mode 100644 doc/rst/pair_eim.rst create mode 100644 doc/rst/pair_exp6_rx.rst create mode 100644 doc/rst/pair_extep.rst create mode 100644 doc/rst/pair_fep_soft.rst create mode 100644 doc/rst/pair_gauss.rst create mode 100644 doc/rst/pair_gayberne.rst create mode 100644 doc/rst/pair_gran.rst create mode 100644 doc/rst/pair_granular.rst create mode 100644 doc/rst/pair_gromacs.rst create mode 100644 doc/rst/pair_gw.rst create mode 100644 doc/rst/pair_hbond_dreiding.rst create mode 100644 doc/rst/pair_hybrid.rst create mode 100644 doc/rst/pair_ilp_graphene_hbn.rst create mode 100644 doc/rst/pair_kim.rst create mode 100644 doc/rst/pair_kolmogorov_crespi_full.rst create mode 100644 doc/rst/pair_kolmogorov_crespi_z.rst create mode 100644 doc/rst/pair_lcbop.rst create mode 100644 doc/rst/pair_lebedeva_z.rst create mode 100644 doc/rst/pair_line_lj.rst create mode 100644 doc/rst/pair_list.rst create mode 100644 doc/rst/pair_lj.rst create mode 100644 doc/rst/pair_lj96.rst create mode 100644 doc/rst/pair_lj_cubic.rst create mode 100644 doc/rst/pair_lj_expand.rst create mode 100644 doc/rst/pair_lj_long.rst create mode 100644 doc/rst/pair_lj_smooth.rst create mode 100644 doc/rst/pair_lj_smooth_linear.rst create mode 100644 doc/rst/pair_lj_switch3_coulgauss.rst create mode 100644 doc/rst/pair_lubricate.rst create mode 100644 doc/rst/pair_lubricateU.rst create mode 100644 doc/rst/pair_mdf.rst create mode 100644 doc/rst/pair_meam_spline.rst create mode 100644 doc/rst/pair_meam_sw_spline.rst create mode 100644 doc/rst/pair_meamc.rst create mode 100644 doc/rst/pair_meso.rst create mode 100644 doc/rst/pair_mgpt.rst create mode 100644 doc/rst/pair_mie.rst create mode 100644 doc/rst/pair_mm3_switch3_coulgauss.rst create mode 100644 doc/rst/pair_modify.rst create mode 100644 doc/rst/pair_momb.rst create mode 100644 doc/rst/pair_morse.rst create mode 100644 doc/rst/pair_multi_lucy.rst create mode 100644 doc/rst/pair_multi_lucy_rx.rst create mode 100644 doc/rst/pair_nb3b_harmonic.rst create mode 100644 doc/rst/pair_nm.rst create mode 100644 doc/rst/pair_none.rst create mode 100644 doc/rst/pair_oxdna.rst create mode 100644 doc/rst/pair_oxdna2.rst create mode 100644 doc/rst/pair_peri.rst create mode 100644 doc/rst/pair_polymorphic.rst create mode 100644 doc/rst/pair_python.rst create mode 100644 doc/rst/pair_quip.rst create mode 100644 doc/rst/pair_reaxc.rst create mode 100644 doc/rst/pair_resquared.rst create mode 100644 doc/rst/pair_sdk.rst create mode 100644 doc/rst/pair_sdpd_taitwater_isothermal.rst create mode 100644 doc/rst/pair_smd_hertz.rst create mode 100644 doc/rst/pair_smd_tlsph.rst create mode 100644 doc/rst/pair_smd_triangulated_surface.rst create mode 100644 doc/rst/pair_smd_ulsph.rst create mode 100644 doc/rst/pair_smtbq.rst create mode 100644 doc/rst/pair_snap.rst create mode 100644 doc/rst/pair_soft.rst create mode 100644 doc/rst/pair_sph_heatconduction.rst create mode 100644 doc/rst/pair_sph_idealgas.rst create mode 100644 doc/rst/pair_sph_lj.rst create mode 100644 doc/rst/pair_sph_rhosum.rst create mode 100644 doc/rst/pair_sph_taitwater.rst create mode 100644 doc/rst/pair_sph_taitwater_morris.rst create mode 100644 doc/rst/pair_spin_dipole.rst create mode 100644 doc/rst/pair_spin_dmi.rst create mode 100644 doc/rst/pair_spin_exchange.rst create mode 100644 doc/rst/pair_spin_magelec.rst create mode 100644 doc/rst/pair_spin_neel.rst create mode 100644 doc/rst/pair_srp.rst create mode 100644 doc/rst/pair_style.rst create mode 100644 doc/rst/pair_sw.rst create mode 100644 doc/rst/pair_table.rst create mode 100644 doc/rst/pair_table_rx.rst create mode 100644 doc/rst/pair_tersoff.rst create mode 100644 doc/rst/pair_tersoff_mod.rst create mode 100644 doc/rst/pair_tersoff_zbl.rst create mode 100644 doc/rst/pair_thole.rst create mode 100644 doc/rst/pair_tri_lj.rst create mode 100644 doc/rst/pair_ufm.rst create mode 100644 doc/rst/pair_vashishta.rst create mode 100644 doc/rst/pair_write.rst create mode 100644 doc/rst/pair_yukawa.rst create mode 100644 doc/rst/pair_yukawa_colloid.rst create mode 100644 doc/rst/pair_zbl.rst create mode 100644 doc/rst/pair_zero.rst create mode 100644 doc/rst/pairs.rst create mode 100644 doc/rst/partition.rst create mode 100644 doc/rst/prd.rst create mode 100644 doc/rst/print.rst create mode 100644 doc/rst/processors.rst create mode 100644 doc/rst/python.rst create mode 100644 doc/rst/quit.rst create mode 100644 doc/rst/read_data.rst create mode 100644 doc/rst/read_dump.rst create mode 100644 doc/rst/read_restart.rst create mode 100644 doc/rst/region.rst create mode 100644 doc/rst/replicate.rst create mode 100644 doc/rst/rerun.rst create mode 100644 doc/rst/reset_ids.rst create mode 100644 doc/rst/reset_timestep.rst create mode 100644 doc/rst/restart.rst create mode 100644 doc/rst/run.rst create mode 100644 doc/rst/run_style.rst create mode 100644 doc/rst/server.rst create mode 100644 doc/rst/server_mc.rst create mode 100644 doc/rst/server_md.rst create mode 100644 doc/rst/set.rst create mode 100644 doc/rst/shell.rst create mode 100644 doc/rst/special_bonds.rst create mode 100644 doc/rst/suffix.rst create mode 100644 doc/rst/tad.rst create mode 100644 doc/rst/temper.rst create mode 100644 doc/rst/temper_grem.rst create mode 100644 doc/rst/temper_npt.rst create mode 100644 doc/rst/thermo.rst create mode 100644 doc/rst/thermo_modify.rst create mode 100644 doc/rst/thermo_style.rst create mode 100644 doc/rst/timer.rst create mode 100644 doc/rst/timestep.rst create mode 100644 doc/rst/uncompute.rst create mode 100644 doc/rst/undump.rst create mode 100644 doc/rst/unfix.rst create mode 100644 doc/rst/units.rst create mode 100644 doc/rst/variable.rst create mode 100644 doc/rst/velocity.rst create mode 100644 doc/rst/write_coeff.rst create mode 100644 doc/rst/write_data.rst create mode 100644 doc/rst/write_dump.rst create mode 100644 doc/rst/write_restart.rst diff --git a/doc/.gitignore b/doc/.gitignore index 88679898a8..ca450f00f9 100644 --- a/doc/.gitignore +++ b/doc/.gitignore @@ -6,3 +6,5 @@ /LAMMPS.mobi /Manual.pdf /Developer.pdf +/doctrees +/docenv diff --git a/doc/Makefile b/doc/Makefile index 5c679440b8..4e8b361fdc 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -2,7 +2,7 @@ SHELL = /bin/bash SHA1 = $(shell echo ${USER}-${PWD} | python utils/sha1sum.py) -BUILDDIR = /tmp/lammps-docs-$(SHA1) +BUILDDIR = ${PWD} RSTDIR = $(BUILDDIR)/rst VENV = $(BUILDDIR)/docenv TXT2RST = $(VENV)/bin/txt2rst @@ -31,7 +31,7 @@ SPHINXEXTRA = -j $(shell $(PYTHON) -c 'import multiprocessing;print(multiprocess SOURCES=$(filter-out $(wildcard src/lammps_commands*.txt) src/lammps_support.txt src/lammps_tutorials.txt,$(wildcard src/*.txt)) OBJECTS=$(SOURCES:src/%.txt=$(RSTDIR)/%.rst) -.PHONY: help clean-all clean epub mobi html pdf old venv spelling anchor_check +.PHONY: help clean-all clean epub mobi rst html pdf old venv spelling anchor_check # ------------------------------------------ @@ -53,19 +53,22 @@ help: # ------------------------------------------ clean-all: clean - rm -rf $(BUILDDIR)/* utils/txt2html/txt2html.exe + rm -rf $(BUILDDIR)/docenv $(BUILDDIR)/doctrees utils/txt2html/txt2html.exe clean: - rm -rf $(RSTDIR) html old epub latex + rm -rf $(RSTDIR)/{Eqs,JPG,*.rst} html old epub latex rm -rf spelling clean-spelling: rm -rf spelling +rst: clean $(OBJECTS) $(ANCHORCHECK) + html: $(OBJECTS) $(ANCHORCHECK) @(\ . $(VENV)/bin/activate ;\ - cp -r src/* $(RSTDIR)/ ;\ + cp -r src/JPG $(RSTDIR)/ ;\ + cp -r src/Eqs $(RSTDIR)/ ;\ sphinx-build $(SPHINXEXTRA) -b html -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) html ;\ echo "############################################" ;\ doc_anchor_check src/*.txt ;\ @@ -88,7 +91,6 @@ spelling: $(OBJECTS) utils/sphinx-config/false_positives.txt @(\ . $(VENV)/bin/activate ;\ pip install sphinxcontrib-spelling ;\ - cp -r src/* $(RSTDIR)/ ;\ cp utils/sphinx-config/false_positives.txt $(RSTDIR)/ ;\ sphinx-build -b spelling -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) spelling ;\ deactivate ;\ @@ -102,7 +104,6 @@ epub: $(OBJECTS) @cp src/JPG/*.* epub/JPG @(\ . $(VENV)/bin/activate ;\ - cp -r src/* $(RSTDIR)/ ;\ sphinx-build $(SPHINXEXTRA) -b epub -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) epub ;\ deactivate ;\ ) @@ -125,7 +126,6 @@ pdf: $(OBJECTS) $(ANCHORCHECK) ) @(\ . $(VENV)/bin/activate ;\ - cp -r src/* $(RSTDIR)/ ;\ sphinx-build $(SPHINXEXTRA) -b latex -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) latex ;\ echo "############################################" ;\ doc_anchor_check src/*.txt ;\ diff --git a/doc/rst/.gitignore b/doc/rst/.gitignore new file mode 100644 index 0000000000..be126ab4aa --- /dev/null +++ b/doc/rst/.gitignore @@ -0,0 +1,2 @@ +Eqs +JPG diff --git a/doc/rst/Build.rst b/doc/rst/Build.rst new file mode 100644 index 0000000000..2eba3ddd48 --- /dev/null +++ b/doc/rst/Build.rst @@ -0,0 +1,28 @@ +Build LAMMPS +************ + +LAMMPS can be built as an executable or library from source code via +either traditional makefiles (which may require manual editing) +for use with GNU make or gmake, or a build environment generated by CMake +(Unix Makefiles, Xcode, Visual Studio, KDevelop or more). As an +alternative you can download a package with pre-built executables +as described on the :doc:`Install ` doc page. + + +.. toctree:: + :maxdepth: 1 + + Build_cmake + Build_make + Build_link + Build_basics + Build_settings + Build_package + Build_extras + Build_windows + Build_development + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_basics.rst b/doc/rst/Build_basics.rst new file mode 100644 index 0000000000..0f454994a5 --- /dev/null +++ b/doc/rst/Build_basics.rst @@ -0,0 +1,437 @@ +Basic build options +=================== + +The following topics are covered on this page, for building both with +CMake and make: + +* :ref:`Serial vs parallel build ` +* :ref:`Choice of compiler and compile/link options ` +* :ref:`Build LAMMPS as an executable or a library ` +* :ref:`Build the LAMMPS documentation ` +* :ref:`Install LAMMPS after a build ` + + +---------- + + +.. _serial: + +Serial vs parallel build +------------------------------------- + +LAMMPS can be built to run in parallel using the ubiquitous `MPI (message-passing interface) `_ +library. Or it can built to run on a single processor (serial) +without MPI. It can also be built with support for OpenMP threading +(see more discussion below). + +**CMake variables**\ : + + +.. parsed-literal:: + + -D BUILD_MPI=value # yes or no, default is yes if CMake finds MPI, else no + -D BUILD_OMP=value # yes or no (default) + -D LAMMPS_MACHINE=name # name = mpi, serial, mybox, titan, laptop, etc + # no default value + +The executable created by CMake (after running make) is lmp\_name. If +the LAMMPS\_MACHINE variable is not specified, the executable is just +lmp. Using BUILD\_MPI=no will produce a serial executable. + +**Traditional make**\ : + + +.. parsed-literal:: + + cd lammps/src + make mpi # parallel build, produces lmp_mpi using Makefile.mpi + make serial # serial build, produces lmp_serial using Makefile/serial + make mybox # uses Makefile.mybox to produce lmp_mybox + +Serial build (see src/MAKE/Makefile.serial): + + +.. parsed-literal:: + + MPI_INC = -I../STUBS + MPI_PATH = -L../STUBS + MPI_LIB = -lmpi_stubs + +For a parallel build, if MPI is installed on your system in the usual +place (e.g. under /usr/local), you do not need to specify the 3 +variables MPI\_INC, MPI\_PATH, MPI\_LIB. The MPI wrapper on the compiler +(e.g. mpicxx, mpiCC) knows where to find the needed include and +library files. Failing this, these 3 variables can be used to specify +where the mpi.h file (MPI\_INC), and the MPI library files (MPI\_PATH) +are found, and the name of the library files (MPI\_LIB). + +For a serial build, you need to specify the 3 variables, as shown +above. + +For a serial LAMMPS build, use the dummy MPI library provided in +src/STUBS. You also need to build the STUBS library for your platform +before making LAMMPS itself. A "make serial" build does this for. +Otherwise, type "make mpi-stubs" from the src directory, or "make" +from the src/STUBS dir. If the build fails, you will need to edit the +STUBS/Makefile for your platform. + +The file STUBS/mpi.c provides a CPU timer function called MPI\_Wtime() +that calls gettimeofday() . If your system doesn't support +gettimeofday() , you'll need to insert code to call another timer. +Note that the ANSI-standard function clock() rolls over after an hour +or so, and is therefore insufficient for timing long LAMMPS +simulations. + +**CMake and make info**\ : + +If you are installing MPI yourself, we recommend MPICH2 from Argonne +National Laboratory or OpenMPI. MPICH can be downloaded from the +`Argonne MPI site `_. +OpenMPI can be downloaded from the `OpenMPI site `_. Other MPI packages should also work. +If you are running on a large parallel machine, your system admins or +the vendor should have already installed a version of MPI, which is +likely to be faster than a self-installed MPICH or OpenMPI, so find +out how to build and link with it. + +The majority of OpenMP (threading) support in LAMMPS is provided by +the USER-OMP package; see the :doc:`Speed omp ` doc page for +details. The USER-INTEL package also provides OpenMP support (it is +compatible with USER-OMP) and adds vectorization support when compiled +with the Intel compilers on top of that. Also, the KOKKOS package can +be compiled for using OpenMP threading. + +However, there are a few commands in LAMMPS that have native OpenMP +support. These are commands in the MPIIO, SNAP, USER-DIFFRACTION, and +USER-DPD packages. In addition some packages support OpenMP threading +indirectly through the libraries they interface to: e.g. LATTE and +USER-COLVARS. See the :doc:`Packages details ` doc +page for more info on these packages and the doc pages for their +respective commands for OpenMP threading info. + +For CMake, if you use BUILD\_OMP=yes, you can use these packages and +turn on their native OpenMP support and turn on their native OpenMP +support at run time, by setting the OMP\_NUM\_THREADS environment +variable before you launch LAMMPS. + +For building via conventional make, the CCFLAGS and LINKFLAGS +variables in Makefile.machine need to include the compiler flag that +enables OpenMP. For GNU compilers it is -fopenmp. For (recent) Intel +compilers it is -qopenmp. If you are using a different compiler, +please refer to its documentation. + +.. _default-none-issues: + +**OpenMP Compiler compatibility info**\ : + +Some compilers do not fully support the 'default(none)' directive +and others (e.g. GCC version 9 and beyond) may implement OpenMP 4.0 +semantics, which are incompatible with the OpenMP 3.1 directives used +in LAMMPS (for maximal compatibility with compiler versions in use). +In those case, all 'default(none)' directives (which aid in detecting +incorrect and unwanted sharing) can be replaced with 'default(shared)' +while dropping all 'shared()' directives. The script +'src/USER-OMP/hack\_openmp\_for\_pgi\_gcc9.sh' can be used to automate +this conversion. + + +---------- + + +.. _compile: + +Choice of compiler and compile/link options +--------------------------------------------------------- + +The choice of compiler and compiler flags can be important for +performance. Vendor compilers can produce faster code than +open-source compilers like GNU. On boxes with Intel CPUs, we suggest +trying the `Intel C++ compiler `_. + +.. _intel: https://software.intel.com/en-us/intel-compilers + + + +On parallel clusters or supercomputers which use "modules" for their +compile/link environments, you can often access different compilers by +simply loading the appropriate module before building LAMMPS. + +**CMake variables**\ : + + +.. parsed-literal:: + + -D CMAKE_CXX_COMPILER=name # name of C++ compiler + -D CMAKE_C_COMPILER=name # name of C compiler + -D CMAKE_Fortran_COMPILER=name # name of Fortran compiler + + -D CMAKE_CXX_FLAGS=string # flags to use with C++ compiler + -D CMAKE_C_FLAGS=string # flags to use with C compiler + -D CMAKE_Fortran_FLAGS=string # flags to use with Fortran compiler + +By default CMake will use a compiler it finds and it will add +optimization flags appropriate to that compiler and any :doc:`accelerator packages ` you have included in the build. + +You can tell CMake to look for a specific compiler with these variable +settings. Likewise you can specify the FLAGS variables if you want to +experiment with alternate optimization flags. You should specify all +3 compilers, so that the small number of LAMMPS source files written +in C or Fortran are built with a compiler consistent with the one used +for all the C++ files: + + +.. parsed-literal:: + + Building with GNU Compilers: + cmake ../cmake -DCMAKE_C_COMPILER=gcc -DCMAKE_CXX_COMPILER=g++ -DCMAKE_Fortran_COMPILER=gfortran + Building with Intel Compilers: + cmake ../cmake -DCMAKE_C_COMPILER=icc -DCMAKE_CXX_COMPILER=icpc -DCMAKE_Fortran_COMPILER=ifort + Building with LLVM/Clang Compilers: + cmake ../cmake -DCMAKE_C_COMPILER=clang -DCMAKE_CXX_COMPILER=clang++ -DCMAKE_Fortran_COMPILER=flang + +.. note:: + + When the cmake command completes, it prints info to the screen + as to which compilers it is using, and what flags will be used in the + compilation. Note that if the top-level compiler is mpicxx, it is + simply a wrapper on a real compiler. The underlying compiler info is + what will be listed in the CMake output. You should check to insure + you are using the compiler and optimization flags are the ones you + want. + +**Makefile.machine settings**\ : + +Parallel build (see src/MAKE/Makefile.mpi): + + +.. parsed-literal:: + + CC = mpicxx + CCFLAGS = -g -O3 + LINK = mpicxx + LINKFLAGS = -g -O + +Serial build (see src/MAKE/Makefile.serial): + + +.. parsed-literal:: + + CC = g++ + CCFLAGS = -g -O3 + LINK = g++ + LINKFLAGS = -g -O + +The "compiler/linker settings" section of a Makefile.machine lists +compiler and linker settings for your C++ compiler, including +optimization flags. You should always use mpicxx or mpiCC for +a parallel build, since these compiler wrappers will include +a variety of settings appropriate for your MPI installation. + +.. note:: + + If you build LAMMPS with any :doc:`accelerator packages ` included, they have specific + optimization flags that are either required or recommended for optimal + performance. You need to include these in the CCFLAGS and LINKFLAGS + settings above. For details, see the individual package doc pages + listed on the :doc:`Speed packages ` doc page. Or + examine these files in the src/MAKE/OPTIONS directory. They + correspond to each of the 5 accelerator packages and their hardware + variants: + + +.. parsed-literal:: + + Makefile.opt # OPT package + Makefile.omp # USER-OMP package + Makefile.intel_cpu # USER-INTEL package for CPUs + Makefile.intel_coprocessor # USER-INTEL package for KNLs + Makefile.gpu # GPU package + Makefile.kokkos_cuda_mpi # KOKKOS package for GPUs + Makefile.kokkos_omp # KOKKOS package for CPUs (OpenMP) + Makefile.kokkos_phi # KOKKOS package for KNLs (OpenMP) + + +---------- + + +.. _exe: + +Build LAMMPS as an executable or a library +---------------------------------------------------- + +LAMMPS can be built as either an executable or as a static or shared +library. The LAMMPS library can be called from another application or +a scripting language. See the :doc:`Howto couple ` doc +page for more info on coupling LAMMPS to other codes. See the +:doc:`Python ` doc page for more info on wrapping and +running LAMMPS from Python via its library interface. + +**CMake variables**\ : + + +.. parsed-literal:: + + -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) + -D LAMMPS_LIB_SUFFIX=name # name = mpi, serial, mybox, titan, laptop, etc + # no default value + +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. If LAMMPS\_LIB\_SUFFIX is set the generated +libraries will be named liblammps\_name.a or liblammps\_name.so instead. + +**Traditional make**\ : + + +.. parsed-literal:: + + cd lammps/src + make machine # build LAMMPS executable lmp_machine + make mode=lib machine # build LAMMPS static lib liblammps_machine.a + make mode=shlib machine # build LAMMPS shared lib liblammps_machine.so + +The two library builds also create generic soft links, named +liblammps.a and liblammps.so, which point to the liblammps\_machine +files. + +**CMake and make info**\ : + +Note that for a shared library to be usable by a calling program, all +the auxiliary libraries it depends on must also exist as shared +libraries. This will be the case for libraries included with LAMMPS, +such as the dummy MPI library in src/STUBS or any package libraries in +the lib/packages directory, since they are always built as shared +libraries using the -fPIC switch. However, if a library like MPI or +FFTW does not exist as a shared library, the shared library build will +generate an error. This means you will need to install a shared +library version of the auxiliary library. The build instructions for +the library should tell you how to do this. + +As an example, here is how to build and install the `MPICH library `_, a popular open-source version of MPI, distributed by +Argonne National Lab, as a shared library in the default +/usr/local/lib location: + +.. _mpich: http://www-unix.mcs.anl.gov/mpi + + + + +.. parsed-literal:: + + ./configure --enable-shared + make + make install + +You may need to use "sudo make install" in place of the last line if +you do not have write privileges for /usr/local/lib. The end result +should be the file /usr/local/lib/libmpich.so. + + +---------- + + +.. _doc: + +Build the LAMMPS documentation +---------------------------------------- + +**CMake variable**\ : + + +.. parsed-literal:: + + -D BUILD_DOC=value # yes or no (default) + +This will create the HTML doc pages within the CMake build directory. +The reason to do this is if you want to "install" LAMMPS on a system +after the CMake build via "make install", and include the doc pages in +the install. + +**Traditional make**\ : + + +.. parsed-literal:: + + cd lammps/doc + make html # html doc pages + make pdf # single Manual.pdf file + +This will create a lammps/doc/html dir with the HTML doc pages so that +you can browse them locally on your system. Type "make" from the +lammps/doc dir to see other options. + +.. note:: + + You can also download a tarball of the documentation for the + current LAMMPS version (HTML and PDF files), from the website + `download page `_. + + +---------- + + +.. _tools: + +Build LAMMPS tools +------------------------------ + +Some tools described in :doc:`Auxiliary tools ` can be built directly +using CMake or Make. + +**CMake variable**\ : + + +.. parsed-literal:: + + -D BUILD_TOOLS=value # yes or no (default) + +The generated binaries will also become part of the LAMMPS installation (see below) + +**Traditional make**\ : + + +.. parsed-literal:: + + 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 + + +---------- + + +.. _install: + +Install LAMMPS after a build +------------------------------------------ + +After building LAMMPS, you may wish to copy the LAMMPS executable of +library, along with other LAMMPS files (library header, doc files) to +a globally visible place on your system, for others to access. Note +that you may need super-user privileges (e.g. sudo) if the directory +you want to copy files to is protected. + +**CMake variable**\ : + + +.. parsed-literal:: + + cmake -D CMAKE_INSTALL_PREFIX=path [options ...] ../cmake + make # perform make after CMake command + make install # perform the installation into prefix + +**Traditional make**\ : + +There is no "install" option in the src/Makefile for LAMMPS. If you +wish to do this you will need to first build LAMMPS, then manually +copy the desired LAMMPS files to the appropriate system directories. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_cmake.rst b/doc/rst/Build_cmake.rst new file mode 100644 index 0000000000..78459bb990 --- /dev/null +++ b/doc/rst/Build_cmake.rst @@ -0,0 +1,245 @@ +Build LAMMPS with CMake +======================= + +This page is a short summary of how to use CMake to build LAMMPS. +Details on CMake variables that enable specific LAMMPS build options +are given on the pages linked to from the :doc:`Build ` doc page. + +Richard Berger (Temple U) has also written a `more comprehensive guide `_ +for how to use CMake to build LAMMPS. If you are new to CMake it is a +good place to start. + + +---------- + + +Building LAMMPS with CMake is a two-step process. First you use CMake +to create a build environment in a new directory. On Linux systems, +this will be based on makefiles for use with make. Then you use the +make command to build LAMMPS, which uses the created +Makefile(s). Example: + + +.. parsed-literal:: + + cd lammps # change to the LAMMPS distribution directory + mkdir build; cd build # create a new directory (folder) for build + cmake [options ...] ../cmake # configuration with (command-line) cmake + make # compilation + +The cmake command will detect available features, enable selected +packages and options, and will generate the build environment. By default +this build environment will be created for "Unix Makefiles" on most +platforms and particularly on Linux. However, alternate build tools +(e.g. Ninja) and support files for Integrated Development Environments +(IDE) like Eclipse, CodeBlocks, or Kate can be generated, too. This is +selected via the "-G" command line flag. For the rest of the documentation +we will assume that the build environment is generated for makefiles +and thus the make command will be used to compile and link LAMMPS as +indicated above, producing (by default) an executable called "lmp" and +a library called "liblammps.a" in the "build" folder. When generating +a build environment for the "Ninja" build tool, the build command would +be "ninja" instead of "make". + +If your machine has multiple CPU cores (most do these days), using a +command like "make -jN" (with N being the number of available local +CPU cores) can be much faster. If you plan to do development on +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 may optionally install the LAMMPS executable into +your system with: + + +.. parsed-literal:: + + make install # optional, copy LAMMPS executable & library elsewhere + +This will install the lammps executable and library (if requested), some +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 + + +---------- + + +There are 3 variants of CMake: a command-line version (cmake), a text mode +UI version (ccmake), and a graphical GUI version (cmake-GUI). You can use +any of them interchangeably to configure and create the LAMMPS build +environment. On Linux all the versions produce a Makefile as their +output. See more details on each below. + +You can specify a variety of options with any of the 3 versions, which +affect how the build is performed and what is included in the LAMMPS +executable. Links to pages explaining all the options are listed on +the :doc:`Build ` doc page. + +You must perform the CMake build system generation and compilation in +a new directory you create. It can be anywhere on your local machine. +In these Build pages we assume that you are building in a directory +called "lammps/build". You can perform separate builds independently +with different options, so long as you perform each of them in a +separate directory you create. All the auxiliary files created by one +build process (executable, object files, log files, etc) are stored in +this directory or sub-directories within it that CMake creates. + +.. note:: + + To perform a CMake build, no packages can be installed or a + build been previously attempted in the LAMMPS src directory by using + "make" commands to :doc:`perform a conventional LAMMPS build `. CMake detects if this is the case and + generates an error, telling you to type "make no-all purge" in the src + directory to un-install all packages. The purge removes all the \*.h + files auto-generated by make. + +You must have CMake version 2.8 or later on your system to build +LAMMPS. A handful of LAMMPS packages (KOKKOS, LATTE, MSCG) require a +later version. CMake will print a message telling you if a later +version is required. Installation instructions for CMake are below. + +After the initial build, if you edit LAMMPS source files, or add your +own new files to the source directory, you can just re-type make from +your build directory and it will re-compile only the files that have +changed. If you want to change CMake options you can run cmake (or +ccmake or cmake-gui) again from the same build directory and alter +various options; see details below. Or you can remove the entire build +folder, recreate the directory and start over. + + +---------- + + +**Command-line version of CMake**\ : + + +.. parsed-literal:: + + cmake [options ...] /path/to/lammps/cmake # build from any dir + cmake [options ...] ../cmake # build from lammps/build + +The cmake command takes one required argument, which is the LAMMPS +cmake directory which contains the CMakeLists.txt file. + +The argument can be preceeded or followed by various CMake +command-line options. Several useful ones are: + + +.. parsed-literal:: + + -D CMAKE_INSTALL_PREFIX=path # where to install LAMMPS executable/lib if desired + -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 + -C path/to/preset/file # load some CMake settings before configuring + +All the LAMMPS-specific -D variables that a LAMMPS build supports are +described on the pages linked to from the :doc:`Build ` doc page. +All of these variable names are upper-case and their values are +lower-case, e.g. -D LAMMPS\_SIZES=smallbig. For boolean values, any of +these forms can be used: yes/no, on/off, 1/0. + +On Unix/Linux machines, CMake generates a Makefile by default to +perform the LAMMPS build. Alternate forms of build info can be +generated via the -G switch, e.g. Visual Studio on a Windows machine, +Xcode on MacOS, or KDevelop on Linux. Type "cmake --help" to see the +"Generator" styles of output your system supports. + +.. note:: + + When CMake runs, it prints configuration info to the screen. + You should review this to verify all the features you requested were + enabled, including packages. You can also see what compilers and + compile options will be used for the build. Any errors in CMake + variable syntax will also be flagged, e.g. mis-typed variable names or + variable values. + +CMake creates a CMakeCache.txt file when it runs. This stores all the +settings, so that when running CMake again you can use the current +folder '.' instead of the path to the LAMMPS cmake folder as the +required argument to the CMake command. Either way the existing +settings will be inherited unless the CMakeCache.txt file is removed. + +If you later want to change a setting you can rerun cmake in the build +directory with different setting. Please note that some automatically +detected variables will not change their value when you rerun cmake. +In these cases it is usually better to first remove all the +files/directories in the build directory, or start with a fresh build +directory. + + +---------- + + +**Curses version (terminal-style menu) of CMake**\ : + + +.. parsed-literal:: + + ccmake ../cmake + +You initiate the configuration and build environment generation steps +separately. For the first you have to type **c**\ , for the second you +have to type **g**\ . You may need to type **c** multiple times, and may be +required to edit some of the entries of CMake configuration variables +in between. Please see the `ccmake manual `_ for +more information. + + +---------- + + +**GUI version of CMake**\ : + + +.. parsed-literal:: + + cmake-gui ../cmake + +You initiate the configuration and build environment generation steps +separately. For the first you have to click on the **Configure** button, +for the second you have to click on the **Generate** button. You may +need to click on **Configure** multiple times, and may be required to +edit some of the entries of CMake configuration variables in between. +Please see the `cmake-gui manual `_ +for more information. + + +---------- + + +**Installing CMake** + +Check if your machine already has CMake installed: + + +.. parsed-literal:: + + which cmake # do you have it? + which cmake3 # version 3 may have this name + cmake --version # what specific version you have + +On clusters or supercomputers which use environment modules to manage +software packages, do this: + + +.. parsed-literal:: + + module list # is a cmake module already loaded? + module avail # is a cmake module available? + module load cmake3 # load cmake module with appropriate name + +Most Linux distributions offer pre-compiled cmake packages through +their package management system. If you do not have CMake or a new +enough version, you can download the latest version at +`https://cmake.org/download/ `_. +Instructions on how to install it on various platforms can be found +`on this page `_. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_development.rst b/doc/rst/Build_development.rst new file mode 100644 index 0000000000..7286caf7b3 --- /dev/null +++ b/doc/rst/Build_development.rst @@ -0,0 +1,120 @@ +Development build options (CMake only) +====================================== + +The CMake build of LAMMPS has a few extra options which are useful during +development, testing or debugging. + + +---------- + + +.. _compilation: + +Verify compilation flags +------------------------------------------ + +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. + + +.. parsed-literal:: + + -D CMAKE_VERBOSE_MAKEFILE=value # value = no (default) or yes + +Another way of doing this without reconfiguration is calling make with variable VERBOSE set to 1: + + +.. parsed-literal:: + + make VERBOSE=1 + + +---------- + + +.. _sanitizer: + +Address, Undefined Behavior, and Thread Sanitizer Support +------------------------------------------------------------------------- + +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 `_, +code that runs into `undefined behavior `_ of the +language and `data races `_ 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. + + +.. parsed-literal:: + + -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 + + +---------- + + +.. _testing: + +Code Coverage and 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 + + +.. parsed-literal:: + + -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 + +If you enable testing in the CMake build it will create an additional target called "test". You can run them with: + + +.. parsed-literal:: + + make test + +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. + + +.. parsed-literal:: + + -D ENABLE_COVERAGE=value # enable coverage measurements, value = no (default) or yes + +This will also add the following targets to generate coverage reports after running the LAMMPS executable: + + +.. parsed-literal:: + + 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 + +These reports require GCOVR to be installed. The easiest way to do this to install it via pip: + + +.. parsed-literal:: + + pip install git+https://github.com/gcovr/gcovr.git + + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_extras.rst b/doc/rst/Build_extras.rst new file mode 100644 index 0000000000..88b4bc2764 --- /dev/null +++ b/doc/rst/Build_extras.rst @@ -0,0 +1,1369 @@ +Packages with extra build options +================================= + +When building with some packages, additional steps may be required, +in addition to: + + +.. parsed-literal:: + + -D PKG_NAME=yes # CMake + make yes-name # make + +as described on the :doc:`Build\_package ` doc page. + +For a CMake build there may be additional optional or required +variables to set. For a build with make, a provided library under the +lammps/lib directory may need to be built first. Or an external +library may need to exist on your system or be downloaded and built. +You may need to tell LAMMPS where it is found on your system. + +This is the list of packages that may require additional steps. + ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`COMPRESS ` | :ref:`GPU ` | :ref:`KIM ` | :ref:`KOKKOS ` | :ref:`LATTE ` | :ref:`MESSAGE ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`MSCG ` | :ref:`OPT ` | :ref:`POEMS ` | :ref:`PYTHON ` | :ref:`VORONOI ` | :ref:`USER-ADIOS ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-ATC ` | :ref:`USER-AWPMD ` | :ref:`USER-COLVARS ` | :ref:`USER-H5MD ` | :ref:`USER-INTEL ` | :ref:`USER-MOLFILE ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-NETCDF ` | :ref:`USER-PLUMED ` | :ref:`USER-OMP ` | :ref:`USER-QMMM ` | :ref:`USER-QUIP ` | :ref:`USER-SCAFACOS ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-SMD ` | :ref:`USER-VTK ` | | | | | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ + + +---------- + + +.. _compress: + +COMPRESS package +------------------------------- + +To build with this package you must have the zlib compression library +available on your system. + +**CMake build**\ : + +If CMake cannot find the library, you can set these variables: + + +.. parsed-literal:: + + -D ZLIB_INCLUDE_DIR=path # path to zlib.h header file + -D ZLIB_LIBRARIES=path # path to libz.a (.so) file + +**Traditional make**\ : + +If make cannot find the library, you can edit the +lib/compress/Makefile.lammps file to specify the paths and library +name. + + +---------- + + +.. _gpu: + +GPU package +--------------------- + +To build with this package, you must choose options for precision and +which GPU hardware to build for. + +**CMake build**\ : + + +.. parsed-literal:: + + -D GPU_API=value # value = opencl (default) or cuda + -D GPU_PREC=value # precision setting + # value = double or mixed (default) or single + -D OCL_TUNE=value # hardware choice for GPU_API=opencl + # 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 sm_30 + -D CUDPP_OPT=value # optimization setting for GPU_API=cuda + # enables CUDA Performance Primitives Optimizations + # value = yes (default) or no + -D CUDA_MPS_SUPPORT=value # enables some tweaks required to run with active nvidia-cuda-mps daemon + # value = yes or no (default) + +GPU\_ARCH settings for different GPU hardware is as follows: + +* sm\_12 or sm\_13 for GT200 (supported by CUDA 3.2 until CUDA 6.5) +* sm\_20 or sm\_21 for Fermi (supported by CUDA 3.2 until CUDA 7.5) +* sm\_30 or sm\_35 or sm\_37 for Kepler (supported since CUDA 5) +* sm\_50 or sm\_52 for Maxwell (supported since CUDA 6) +* sm\_60 or sm\_61 for Pascal (supported since CUDA 8) +* sm\_70 for Volta (supported since CUDA 9) +* sm\_75 for Turing (supported since CUDA 10) + +A more detailed list can be found, for example, +at `Wikipedia's CUDA article `_ + +CMake can detect which version of the CUDA toolkit is used and thus can +include support for **all** major GPU architectures supported by this toolkit. +Thus the GPU\_ARCH setting is merely an optimization, to have code for +the preferred GPU architecture directly included rather than having to wait +for the JIT compiler of the CUDA driver to translate it. + +**Traditional make**\ : + +Before building LAMMPS, you must build the GPU library in lib/gpu. +You can do this manually if you prefer; follow the instructions in +lib/gpu/README. Note that the GPU library uses MPI calls, so you must +use the same MPI library (or the STUBS library) settings as the main +LAMMPS code. This also applies to the -DLAMMPS\_BIGBIG, +-DLAMMPS\_SMALLBIG, or -DLAMMPS\_SMALLSMALL settings in whichever +Makefile you use. + +You can also build the library in one step from the lammps/src dir, +using a command like these, which simply invoke the lib/gpu/Install.py +script with the specified args: + + +.. parsed-literal:: + + make lib-gpu # print help message + make lib-gpu args="-b" # build GPU library with default Makefile.linux + make lib-gpu args="-m xk7 -p single -o xk7.single" # create new Makefile.xk7.single, altered for single-precision + make lib-gpu args="-m mpi -a sm_60 -p mixed -b" # build GPU library with mixed precision and P100 using other settings in Makefile.mpi + +Note that this procedure starts with a Makefile.machine in lib/gpu, as +specified by the "-m" switch. For your convenience, machine makefiles +for "mpi" and "serial" are provided, which have the same settings as +the corresponding machine makefiles in the main LAMMPS source +folder. In addition you can alter 4 important settings in the +Makefile.machine you start from via the corresponding -c, -a, -p, -e +switches (as in the examples above), and also save a copy of the new +Makefile if desired: + +* CUDA\_HOME = where NVIDIA CUDA software is installed on your system +* CUDA\_ARCH = sm\_XX, what GPU hardware you have, same as CMake GPU\_ARCH above +* CUDA\_PRECISION = precision (double, mixed, single) +* EXTRAMAKE = which Makefile.lammps.\* file to copy to Makefile.lammps + +The file Makefile.linux\_multi is set up to include support for multiple +GPU architectures as supported by the CUDA toolkit in use. This is done +through using the "--gencode " flag, which can be used multiple times and +thus support all GPU architectures supported by your CUDA compiler. + +If the library build is successful, 3 files should be created: +lib/gpu/libgpu.a, lib/gpu/nvc\_get\_devices, and +lib/gpu/Makefile.lammps. The latter has settings that enable LAMMPS +to link with CUDA libraries. If the settings in Makefile.lammps for +your machine are not correct, the LAMMPS build will fail, and +lib/gpu/Makefile.lammps may need to be edited. + +.. note:: + + If you re-build the GPU library in lib/gpu, you should always + un-install the GPU package in lammps/src, then re-install it and + re-build LAMMPS. This is because the compilation of files in the GPU + package uses the library settings from the lib/gpu/Makefile.machine + used to build the GPU library. + + +---------- + + +.. _kim: + +KIM package +--------------------- + +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 :doc:`kim\_query ` +command, you also need to have libcurl installed with the matching +development headers and the curl-config tool. + +See `Obtaining KIM 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 + +(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**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_KIM=value # download OpenKIM API v2 for build, value = no (default) or yes + +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. + +**Traditional make**\ : + +You can download and build the KIM library manually if you prefer; +follow the instructions in lib/kim/README. You can also do it in one +step from the lammps/src dir, using a command like these, which simply +invoke the lib/kim/Install.py script with the specified args. + + +.. parsed-literal:: + + make lib-kim # print help message + make lib-kim args="-b " # (re-)install KIM API lib with only example models + make lib-kim args="-b -a Glue_Ercolessi_Adams_Al__MO_324507536345_001" # ditto plus one model + make lib-kim args="-b -a everything" # install KIM API lib with all models + make lib-kim args="-n -a EAM_Dynamo_Ackland_W__MO_141627196590_002" # add one model or model driver + make lib-kim args="-p /usr/local" # use an existing KIM API installation at the provided location + make lib-kim args="-p /usr/local -a EAM_Dynamo_Ackland_W__MO_141627196590_002" # ditto but add one model or driver + + +---------- + + +.. _kokkos: + +KOKKOS package +--------------------------- + +To build with this package, you must choose which hardware you want to +build for, either CPUs (multi-threading via OpenMP) or KNLs (OpenMP) +or GPUs (NVIDIA Cuda). + +For a CMake or make build, these are the possible choices for the +KOKKOS\_ARCH settings described below. Note that for CMake, these are +really Kokkos variables, not LAMMPS variables. Hence you must use +case-sensitive values, e.g. BDW, not bdw. + +* ARMv80 = ARMv8.0 Compatible CPU +* ARMv81 = ARMv8.1 Compatible CPU +* ARMv8-ThunderX = ARMv8 Cavium ThunderX CPU +* BGQ = IBM Blue Gene/Q CPUs +* Power8 = IBM POWER8 CPUs +* Power9 = IBM POWER9 CPUs +* SNB = Intel Sandy/Ivy Bridge CPUs +* HSW = Intel Haswell CPUs +* BDW = Intel Broadwell Xeon E-class CPUs +* SKX = Intel Sky Lake Xeon E-class HPC CPUs (AVX512) +* KNC = Intel Knights Corner Xeon Phi +* KNL = Intel Knights Landing Xeon Phi +* Kepler30 = NVIDIA Kepler generation CC 3.0 +* Kepler32 = NVIDIA Kepler generation CC 3.2 +* Kepler35 = NVIDIA Kepler generation CC 3.5 +* Kepler37 = NVIDIA Kepler generation CC 3.7 +* Maxwell50 = NVIDIA Maxwell generation CC 5.0 +* Maxwell52 = NVIDIA Maxwell generation CC 5.2 +* Maxwell53 = NVIDIA Maxwell generation CC 5.3 +* Pascal60 = NVIDIA Pascal generation CC 6.0 +* Pascal61 = NVIDIA Pascal generation CC 6.1 +* Volta70 = NVIDIA Volta generation CC 7.0 +* Volta72 = NVIDIA Volta generation CC 7.2 +* Turing75 = NVIDIA Turing generation CC 7.5 + +**CMake build**\ : + +For multicore CPUs using OpenMP, set these 2 variables. + + +.. parsed-literal:: + + -D KOKKOS_ARCH=archCPU # archCPU = CPU from list above + -D KOKKOS_ENABLE_OPENMP=yes + +For Intel KNLs using OpenMP, set these 2 variables: + + +.. parsed-literal:: + + -D KOKKOS_ARCH=KNL + -D KOKKOS_ENABLE_OPENMP=yes + +For NVIDIA GPUs using CUDA, set these 4 variables: + + +.. parsed-literal:: + + -D KOKKOS_ARCH="archCPU;archGPU" # archCPU = CPU from list above that is hosting the GPU + # archGPU = GPU from list above + -D KOKKOS_ENABLE_CUDA=yes + -D KOKKOS_ENABLE_OPENMP=yes + -D CMAKE_CXX_COMPILER=wrapper # wrapper = full path to Cuda nvcc wrapper + +The wrapper value is the Cuda nvcc compiler wrapper provided in the +Kokkos library: lib/kokkos/bin/nvcc\_wrapper. The setting should +include the full path name to the wrapper, e.g. + + +.. parsed-literal:: + + -D CMAKE_CXX_COMPILER=/home/username/lammps/lib/kokkos/bin/nvcc_wrapper + +**Traditional make**\ : + +Choose which hardware to support in Makefile.machine via +KOKKOS\_DEVICES and KOKKOS\_ARCH settings. See the +src/MAKE/OPTIONS/Makefile.kokkos\* files for examples. + +For multicore CPUs using OpenMP: + + +.. parsed-literal:: + + KOKKOS_DEVICES = OpenMP + KOKKOS_ARCH = archCPU # archCPU = CPU from list above + +For Intel KNLs using OpenMP: + + +.. parsed-literal:: + + KOKKOS_DEVICES = OpenMP + KOKKOS_ARCH = KNL + +For NVIDIA GPUs using CUDA: + + +.. parsed-literal:: + + KOKKOS_DEVICES = Cuda + KOKKOS_ARCH = archCPU,archGPU # archCPU = CPU from list above that is hosting the GPU + # archGPU = GPU from list above + +For GPUs, you also need these 2 lines in your Makefile.machine before +the CC line is defined, in this case for use with OpenMPI mpicxx. The +2 lines define a nvcc wrapper compiler, which will use nvcc for +compiling CUDA files and use a C++ compiler for non-Kokkos, non-CUDA +files. + + +.. parsed-literal:: + + KOKKOS_ABSOLUTE_PATH = $(shell cd $(KOKKOS_PATH); pwd) + export OMPI_CXX = $(KOKKOS_ABSOLUTE_PATH)/config/nvcc_wrapper + CC = mpicxx + + +---------- + + +.. _latte: + +LATTE package +------------------------- + +To build with this package, you must download and build the LATTE +library. + +**CMake build**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_LATTE=value # download LATTE for build, value = no (default) or yes + -D LATTE_LIBRARY=path # LATTE library file (only needed if a custom location) + +If DOWNLOAD\_LATTE is set, the LATTE library will be downloaded and +built inside the CMake build directory. If the LATTE library is +already on your system (in a location CMake cannot find it), +LATTE\_LIBRARY is the filename (plus path) of the LATTE library file, +not the directory the library file is in. + +**Traditional make**\ : + +You can download and build the LATTE library manually if you prefer; +follow the instructions in lib/latte/README. You can also do it in +one step from the lammps/src dir, using a command like these, which +simply invokes the lib/latte/Install.py script with the specified +args: + + +.. parsed-literal:: + + make lib-latte # print help message + make lib-latte args="-b" # download and build in lib/latte/LATTE-master + make lib-latte args="-p $HOME/latte" # use existing LATTE installation in $HOME/latte + make lib-latte args="-b -m gfortran" # download and build in lib/latte and + # copy Makefile.lammps.gfortran to Makefile.lammps + +Note that 3 symbolic (soft) links, "includelink" and "liblink" and +"filelink.o", are created in lib/latte to point into the LATTE home +dir. When LAMMPS itself is built it will use these links. You should +also check that the Makefile.lammps file you create is appropriate for +the compiler you use on your system to build LATTE. + + +---------- + + +.. _message: + +MESSAGE package +----------------------------- + +This package can optionally include support for messaging via sockets, +using the open-source `ZeroMQ library `_, which must +be installed on your system. + +**CMake build**\ : + + +.. parsed-literal:: + + -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) + +**Traditional make**\ : + +Before building LAMMPS, you must build the CSlib library in +lib/message. You can build the CSlib library manually if you prefer; +follow the instructions in lib/message/README. You can also do it in +one step from the lammps/src dir, using a command like these, which +simply invoke the lib/message/Install.py script with the specified args: + + +.. parsed-literal:: + + 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 + +The build should produce two files: lib/message/cslib/src/libmessage.a +and lib/message/Makefile.lammps. The latter is copied from an +existing Makefile.lammps.\* and has settings to link with the ZeroMQ +library if requested in the build. + + +---------- + + +.. _mscg: + +MSCG package +----------------------- + +To build with this package, you must download and build the MS-CG +library. Building the MS-CG library and using it from LAMMPS requires +a C++11 compatible compiler and that the GSL (GNU Scientific Library) +headers and libraries are installed on your machine. See the +lib/mscg/README and MSCG/Install files for more details. + +**CMake build**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_MSCG=value # download MSCG for build, value = no (default) or yes + -D MSCG_LIBRARY=path # MSCG library file (only needed if a custom location) + -D MSCG_INCLUDE_DIR=path # MSCG include directory (only needed if a custom location) + +If DOWNLOAD\_MSCG is set, the MSCG library will be downloaded and built +inside the CMake build directory. If the MSCG library is already on +your system (in a location CMake cannot find it), MSCG\_LIBRARY is the +filename (plus path) of the MSCG library file, not the directory the +library file is in. MSCG\_INCLUDE\_DIR is the directory the MSCG +include file is in. + +**Traditional make**\ : + +You can download and build the MS-CG library manually if you prefer; +follow the instructions in lib/mscg/README. You can also do it in one +step from the lammps/src dir, using a command like these, which simply +invoke the lib/mscg/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-mscg # print help message + make lib-mscg args="-b -m serial" # download and build in lib/mscg/MSCG-release-master + # with the settings compatible with "make serial" + make lib-mscg args="-b -m mpi" # download and build in lib/mscg/MSCG-release-master + # with the settings compatible with "make mpi" + make lib-mscg args="-p /usr/local/mscg-release" # use the existing MS-CG installation in /usr/local/mscg-release + +Note that 2 symbolic (soft) links, "includelink" and "liblink", will +be created in lib/mscg to point to the MS-CG src/installation dir. +When LAMMPS is built in src it will use these links. You should not +need to edit the lib/mscg/Makefile.lammps file. + + +---------- + + +.. _opt: + +OPT package +--------------------- + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_OPT=yes". + +**Traditional make**\ : + +The compile flag "-restrict" must be used to build LAMMPS with the OPT +package when using Intel compilers. It should be added to the CCFLAGS +line of your Makefile.machine. See src/MAKE/OPTIONS/Makefile.opt for +an example. + + +---------- + + +.. _poems: + +POEMS package +------------------------- + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_OPT=yes". + +**Traditional make**\ : + +Before building LAMMPS, you must build the POEMS library in lib/poems. +You can do this manually if you prefer; follow the instructions in +lib/poems/README. You can also do it in one step from the lammps/src +dir, using a command like these, which simply invoke the +lib/poems/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-poems # print help message + make lib-poems args="-m serial" # build with GNU g++ compiler (settings as with "make serial") + make lib-poems args="-m mpi" # build with default MPI C++ compiler (settings as with "make mpi") + make lib-poems args="-m icc" # build with Intel icc compiler + +The build should produce two files: lib/poems/libpoems.a and +lib/poems/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the +POEMS library (though typically the settings are just blank). If +necessary, you can edit/create a new lib/poems/Makefile.machine file +for your system, which should define an EXTRAMAKE variable to specify +a corresponding Makefile.lammps.machine file. + + +---------- + + +.. _python: + +PYTHON package +--------------------------- + +Building with the PYTHON package requires you have a Python shared +library available on your system, which needs to be a Python 2 +version, 2.6 or later. Python 3 is not yet supported. See +lib/python/README for more details. + +**CMake build**\ : + + +.. parsed-literal:: + + -D PYTHON_EXECUTABLE=path # path to Python executable to use + +Without this setting, CMake will guess the default Python on your +system. To use a different Python version, you can either create a +virtualenv, activate it and then run cmake. Or you can set the +PYTHON\_EXECUTABLE variable to specify which Python interpreter should +be used. Note note that you will also need to have the development +headers installed for this version, e.g. python2-devel. + +**Traditional make**\ : + +The build uses the lib/python/Makefile.lammps file in the compile/link +process to find Python. You should only need to create a new +Makefile.lammps.\* file (and copy it to Makefile.lammps) if the LAMMPS +build fails. + + +---------- + + +.. _voronoi: + +VORONOI package +----------------------------- + +To build with this package, you must download and build the `Voro++ library `_. + +.. _voro-home: http://math.lbl.gov/voro++ + + + +**CMake build**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_VORO=value # download Voro++ for build, value = no (default) or yes + -D VORO_LIBRARY=path # Voro++ library file (only needed if at custom location) + -D VORO_INCLUDE_DIR=path # Voro++ include directory (only needed if at custom location) + +If DOWNLOAD\_VORO is set, the Voro++ library will be downloaded and +built inside the CMake build directory. If the Voro++ library is +already on your system (in a location CMake cannot find it), +VORO\_LIBRARY is the filename (plus path) of the Voro++ library file, +not the directory the library file is in. VORO\_INCLUDE\_DIR is the +directory the Voro++ include file is in. + +**Traditional make**\ : + +You can download and build the Voro++ library manually if you prefer; +follow the instructions in lib/voronoi/README. You can also do it in +one step from the lammps/src dir, using a command like these, which +simply invoke the lib/voronoi/Install.py script with the specified +args: + + +.. parsed-literal:: + + make lib-voronoi # print help message + make lib-voronoi args="-b" # download and build the default version in lib/voronoi/voro++- + make lib-voronoi args="-p $HOME/voro++" # use existing Voro++ installation in $HOME/voro++ + make lib-voronoi args="-b -v voro++0.4.6" # download and build the 0.4.6 version in lib/voronoi/voro++-0.4.6 + +Note that 2 symbolic (soft) links, "includelink" and "liblink", are +created in lib/voronoi to point to the Voro++ src dir. When LAMMPS +builds in src it will use these links. You should not need to edit +the lib/voronoi/Makefile.lammps file. + + +---------- + + +.. _user-adios: + +USER-ADIOS package +----------------------------------- + +The USER-ADIOS package requires the `ADIOS I/O library `_, +version 2.3.1 or newer. Make sure that you have ADIOS built either with or +without MPI to match if you build LAMMPS with or without MPI. +ADIOS compilation settings for LAMMPS are automatically detected, if the PATH +and LD\_LIBRARY\_PATH environment variables have been updated for the local ADIOS +installation and the instructions below are followed for the respective build systems. + +**CMake build**\ : + + +.. parsed-literal:: + + -D ADIOS2_DIR=path # path is where ADIOS 2.x is installed + -D PKG_USER-ADIOS=yes + +**Traditional make**\ : + +Turn on the USER-ADIOS package before building LAMMPS. If the ADIOS 2.x software is installed in PATH, there is nothing else to do: + + +.. parsed-literal:: + + make yes-user-adios + +otherwise, set ADIOS2\_DIR environment variable when turning on the package: + + +.. parsed-literal:: + + ADIOS2_DIR=path make yes-user-adios # path is where ADIOS 2.x is installed + + +---------- + + +.. _user-atc: + +USER-ATC package +------------------------------- + +The USER-ATC package requires the MANYBODY package also be installed. + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-ATC=yes" +and "-D PKG\_MANYBODY=yes". + +**Traditional make**\ : + +Before building LAMMPS, you must build the ATC library in lib/atc. +You can do this manually if you prefer; follow the instructions in +lib/atc/README. You can also do it in one step from the lammps/src +dir, using a command like these, which simply invoke the +lib/atc/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-atc # print help message + make lib-atc args="-m serial" # build with GNU g++ compiler and MPI STUBS (settings as with "make serial") + make lib-atc args="-m mpi" # build with default MPI compiler (settings as with "make mpi") + make lib-atc args="-m icc" # build with Intel icc compiler + +The build should produce two files: lib/atc/libatc.a and +lib/atc/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the ATC +library. If necessary, you can edit/create a new +lib/atc/Makefile.machine file for your system, which should define an +EXTRAMAKE variable to specify a corresponding Makefile.lammps.machine +file. + +Note that the Makefile.lammps file has settings for the BLAS and +LAPACK linear algebra libraries. As explained in lib/atc/README these +can either exist on your system, or you can use the files provided in +lib/linalg. In the latter case you also need to build the library in +lib/linalg with a command like these: + + +.. parsed-literal:: + + make lib-linalg # print help message + make lib-linalg args="-m serial" # build with GNU Fortran compiler (settings as with "make serial") + make lib-linalg args="-m mpi" # build with default MPI Fortran compiler (settings as with "make mpi") + make lib-linalg args="-m gfortran" # build with GNU Fortran compiler + + +---------- + + +.. _user-awpmd: + +USER-AWPMD package +----------------------------------- + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-AQPMD=yes". + +**Traditional make**\ : + +Before building LAMMPS, you must build the AWPMD library in lib/awpmd. +You can do this manually if you prefer; follow the instructions in +lib/awpmd/README. You can also do it in one step from the lammps/src +dir, using a command like these, which simply invoke the +lib/awpmd/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-awpmd # print help message + make lib-awpmd args="-m serial" # build with GNU g++ compiler and MPI STUBS (settings as with "make serial") + make lib-awpmd args="-m mpi" # build with default MPI compiler (settings as with "make mpi") + make lib-awpmd args="-m icc" # build with Intel icc compiler + +The build should produce two files: lib/awpmd/libawpmd.a and +lib/awpmd/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the +AWPMD library. If necessary, you can edit/create a new +lib/awpmd/Makefile.machine file for your system, which should define +an EXTRAMAKE variable to specify a corresponding +Makefile.lammps.machine file. + +Note that the Makefile.lammps file has settings for the BLAS and +LAPACK linear algebra libraries. As explained in lib/awpmd/README +these can either exist on your system, or you can use the files +provided in lib/linalg. In the latter case you also need to build the +library in lib/linalg with a command like these: + + +.. parsed-literal:: + + make lib-linalg # print help message + make lib-linalg args="-m serial" # build with GNU Fortran compiler (settings as with "make serial") + make lib-linalg args="-m mpi" # build with default MPI Fortran compiler (settings as with "make mpi") + make lib-linalg args="-m gfortran" # build with GNU Fortran compiler + + +---------- + + +.. _user-colvars: + +USER-COLVARS package +--------------------------------------- + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-COLVARS=yes". + +**Traditional make**\ : + +Before building LAMMPS, you must build the COLVARS library in +lib/colvars. You can do this manually if you prefer; follow the +instructions in lib/colvars/README. You can also do it in one step +from the lammps/src dir, using a command like these, which simply +invoke the lib/colvars/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-colvars # print help message + make lib-colvars args="-m serial" # build with GNU g++ compiler (settings as with "make serial") + make lib-colvars args="-m mpi" # build with default MPI compiler (settings as with "make mpi") + make lib-colvars args="-m g++-debug" # build with GNU g++ compiler and colvars debugging enabled + +The build should produce two files: lib/colvars/libcolvars.a and +lib/colvars/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the +COLVARS library (though typically the settings are just blank). If +necessary, you can edit/create a new lib/colvars/Makefile.machine file +for your system, which should define an EXTRAMAKE variable to specify +a corresponding Makefile.lammps.machine file. + + +---------- + + +.. _user-plumed: + +USER-PLUMED package +------------------------------------- + +.. _plumedinstall: http://plumed.github.io/doc-master/user-doc/html/\_installation.html + +Before building LAMMPS with this package, you must first build PLUMED. +PLUMED can be built as part of the LAMMPS build or installed separately +from LAMMPS using the generic `plumed installation instructions `_. + + +PLUMED can be linked into MD codes in three different modes: static, +shared, and runtime. With the "static" mode, all the code that PLUMED +requires is linked statically into LAMMPS. LAMMPS is then fully +independent from the PLUMED installation, but you have to rebuild/relink +it in order to update the PLUMED code inside it. With the "shared" +linkage mode, LAMMPS is linked to a shared library that contains the +PLUMED code. This library should preferably be installed in a globally +accessible location. When PLUMED is linked in this way the same library +can be used by multiple MD packages. Furthermore, the PLUMED library +LAMMPS uses can be updated without the need for a recompile of LAMMPS +for as long as the shared PLUMED library is ABI-compatible. + +The third linkage mode is "runtime" which allows the user to specify +which PLUMED kernel should be used at runtime by using the PLUMED\_KERNEL +environment variable. This variable should point to the location of the +libplumedKernel.so dynamical shared object, which is then loaded at +runtime. This mode of linking is particularly convenient for doing +PLUMED development and comparing multiple PLUMED versions as these sorts +of comparisons can be done without recompiling the hosting MD code. All +three linkage modes are supported by LAMMPS on selected operating +systems (e.g. Linux) and using either CMake or traditional make +build. The "static" mode should be the most portable, while the +"runtime" mode support in LAMMPS makes the most assumptions about +operating system and compiler environment. If one mode does not work, +try a different one, switch to a different build system, consider a +global PLUMED installation or consider downloading PLUMED during the +LAMMPS build. + +**CMake build**\ : + +When the "-D PKG\_USER-PLUMED" flag is included in the cmake command you +must ensure that GSL is installed in locations that are specified in +your environment. There are then two additional commands that control +the manner in which PLUMED is obtained and linked into LAMMPS. + + +.. parsed-literal:: + + -D DOWNLOAD_PLUMED=value # download PLUMED for build, value = no (default) or yes + -D PLUMED_MODE=value # Linkage mode for PLUMED, value = static (default), shared, or runtime + +If DOWNLOAD\_PLUMED is set to "yes", the PLUMED library will be +downloaded (the version of PLUMED that will be downloaded is hard-coded +to a vetted version of PLUMED, usually a recent stable release version) +and built inside the CMake build directory. If DOWNLOAD\_PLUMED is set +to "no" (the default), CMake will try to detect and link to an installed +version of PLUMED. For this to work, the PLUMED library has to be +installed into a location where the pkg-config tool can find it or the +PKG\_CONFIG\_PATH environment variable has to be set up accordingly. +PLUMED should be installed in such a location if you compile it using +the default make; make install commands. + +The PLUMED\_MODE setting determines the linkage mode for the PLUMED +library. The allowed values for this flag are "static" (default), +"shared", or "runtime". For a discussion of PLUMED linkage modes, +please see above. When DOWNLOAD\_PLUMED is enabled the static linkage +mode is recommended. + +**Traditional make**\ : + +PLUMED needs to be installed before the USER-PLUMED package is installed +so that LAMMPS can find the right settings when compiling and linking +the LAMMPS executable. You can either download and build PLUMED inside +the LAMMPS plumed library folder or use a previously installed PLUMED +library and point LAMMPS to its location. You also have to choose the +linkage mode: "static" (default), "shared" or "runtime". For a +discussion of PLUMED linkage modes, please see above. + +Download/compilation/configuration of the plumed library can be done +from the src folder through the following make args: + + +.. parsed-literal:: + + make lib-plumed # print help message + make lib-plumed args="-b" # download and build PLUMED in lib/plumed/plumed2 + make lib-plumed args="-p $HOME/.local" # use existing PLUMED installation in $HOME/.local + make lib-plumed args="-p /usr/local -m shared" # use existing PLUMED installation in + # /usr/local and use shared linkage mode + +Note that 2 symbolic (soft) links, "includelink" and "liblink" are +created in lib/plumed that point to the location of the PLUMED build to +use. A new file lib/plumed/Makefile.lammps is also created with settings +suitable for LAMMPS to compile and link PLUMED using the desired linkage +mode. After this step is completed, you can install the USER-PLUMED +package and compile LAMMPS in the usual manner: + + +.. parsed-literal:: + + make yes-user-plumed + make machine + +Once this compilation completes you should be able to run LAMMPS in the +usual way. For shared linkage mode, libplumed.so must be found by the +LAMMPS executable, which on many operating systems means, you have to +set the LD\_LIBRARY\_PATH environment variable accordingly. + +Support for the different linkage modes in LAMMPS varies for different +operating systems, using the static linkage is expected to be the most +portable, and thus set to be the default. + +If you want to change the linkage mode, you have to re-run "make +lib-plumed" with the desired settings **and** do a re-install if the +USER-PLUMED package with "make yes-user-plumed" to update the required +makefile settings with the changes in the lib/plumed folder. + + +---------- + + +.. _user-h5md: + +USER-H5MD package +--------------------------------- + +To build with this package you must have the HDF5 software package +installed on your system, which should include the h5cc compiler and +the HDF5 library. + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-H5MD=yes". + +This should auto-detect the H5MD library on your system. Several +advanced CMake H5MD options exist if you need to specify where it is +installed. Use the ccmake (terminal window) or cmake-gui (graphical) +tools to see these options and set them interactively from their user +interfaces. + +**Traditional make**\ : + +Before building LAMMPS, you must build the CH5MD library in lib/h5md. +You can do this manually if you prefer; follow the instructions in +lib/h5md/README. You can also do it in one step from the lammps/src +dir, using a command like these, which simply invoke the +lib/h5md/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-h5md # print help message + make lib-hm5d args="-m h5cc" # build with h5cc compiler + +The build should produce two files: lib/h5md/libch5md.a and +lib/h5md/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the +system HDF5 library. If necessary, you can edit/create a new +lib/h5md/Makefile.machine file for your system, which should define an +EXTRAMAKE variable to specify a corresponding Makefile.lammps.machine +file. + + +---------- + + +.. _user-intel: + +USER-INTEL package +----------------------------------- + +To build with this package, you must choose which hardware you want to +build for, either x86 CPUs or Intel KNLs in offload mode. You should +also typically :ref:`install the USER-OMP package `, as it can be +used in tandem with the USER-INTEL package to good effect, as explained +on the :doc:`Speed intel ` doc page. + +**CMake build**\ : + + +.. parsed-literal:: + + -D INTEL_ARCH=value # value = cpu (default) or knl + -D INTEL_LRT_MODE=value # value = threads, none, or c++11 + +In Long-range thread mode (LRT) a modified verlet style is used, that +operates the Kspace calculation in a separate thread concurrently to +other calculations. This has to be enabled in the :doc:`package intel ` +command at runtime. With the setting "threads" it used the pthreads +library, while c++11 will use the built-in thread support of C++11 +compilers. The option "none" skips compilation of this feature. The +default is to use "threads" if pthreads is available and otherwise "none". + +Best performance is achieved with Intel hardware, Intel compilers, as well as +the Intel TBB and MKL libraries. However, the code also compiles, links, and +runs with other compilers and without TBB and MKL. + +**Traditional make**\ : + +Choose which hardware to compile for in Makefile.machine via the +following settings. See src/MAKE/OPTIONS/Makefile.intel\_cpu\* and +Makefile.knl files for examples. and src/USER-INTEL/README for +additional information. + +For CPUs: + + +.. parsed-literal:: + + OPTFLAGS = -xHost -O2 -fp-model fast=2 -no-prec-div -qoverride-limits -qopt-zmm-usage=high + CCFLAGS = -g -qopenmp -DLAMMPS_MEMALIGN=64 -no-offload -fno-alias -ansi-alias -restrict $(OPTFLAGS) + LINKFLAGS = -g -qopenmp $(OPTFLAGS) + LIB = -ltbbmalloc + +For KNLs: + + +.. parsed-literal:: + + OPTFLAGS = -xMIC-AVX512 -O2 -fp-model fast=2 -no-prec-div -qoverride-limits + CCFLAGS = -g -qopenmp -DLAMMPS_MEMALIGN=64 -no-offload -fno-alias -ansi-alias -restrict $(OPTFLAGS) + LINKFLAGS = -g -qopenmp $(OPTFLAGS) + LIB = -ltbbmalloc + + +---------- + + +.. _user-molfile: + +USER-MOLFILE package +--------------------------------------- + +**CMake build**\ : + + +.. parsed-literal:: + + -D MOLFILE_INCLUDE_DIRS=path # (optional) path where VMD molfile plugin headers are installed + -D PKG_USER-MOLFILE=yes + +Using "-D PKG\_USER-MOLFILE=yes" enables the package, and setting +"-D MOLFILE\_INCLUDE DIRS" allows to provide a custom location for +the molfile plugin header files. These should match the ABI of the +plugin files used, and thus one typically sets them to include +folder of the local VMD installation in use. LAMMPS ships with a +couple of default header files that correspond to a popular VMD +version, usually the latest release. + +**Traditional make**\ : + +The lib/molfile/Makefile.lammps file has a setting for a dynamic +loading library libdl.a that is typically present on all systems. It +is required for LAMMPS to link with this package. If the setting is +not valid for your system, you will need to edit the Makefile.lammps +file. See lib/molfile/README and lib/molfile/Makefile.lammps for +details. It is also possible to configure a different folder with +the VMD molfile plugin header files. LAMMPS ships with a couple of +default headers, but these are not compatible with all VMD versions, +so it is often best to change this setting to the location of the +same include files of the local VMD installation in use. + + +---------- + + +.. _user-netcdf: + +USER-NETCDF package +------------------------------------- + +To build with this package you must have the NetCDF library installed +on your system. + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-NETCDF=yes". + +This should auto-detect the NETCDF library if it is installed on your +system at standard locations. Several advanced CMake NETCDF options +exist if you need to specify where it was installed. Use the ccmake +(terminal window) or cmake-gui (graphical) tools to see these options +and set them interactively from their user interfaces. + +**Traditional make**\ : + +The lib/netcdf/Makefile.lammps file has settings for NetCDF include +and library files which LAMMPS needs to build with this package. If +the settings are not valid for your system, you will need to edit the +Makefile.lammps file. See lib/netcdf/README for details. + + +---------- + + +.. _user-omp: + +USER-OMP package +------------------------------- + +**CMake build**\ : + +No additional settings are required besides "-D PKG\_USER-OMP=yes". If +CMake detects OpenMP support, the USER-OMP code will be compiled with +multi-threading support enabled, otherwise as optimized serial code. + +**Traditional make**\ : + +To enable multi-threading support in the USER-OMP package (and other +styles supporting OpenMP) the following compile and link flags must +be added to your Makefile.machine file. +See src/MAKE/OPTIONS/Makefile.omp for an example. + + +.. parsed-literal:: + + CCFLAGS: -fopenmp # for GNU Compilers + CCFLAGS: -qopenmp -restrict # for Intel compilers on Linux + LINKFLAGS: -fopenmp # for GNU Compilers + LINKFLAGS: -qopenmp # for Intel compilers on Linux + +For other platforms and compilers, please consult the documentation +about OpenMP support for your compiler. Please see the note about +how to address compatibility :ref:`issues with the 'default(none)' directive ` of some compilers. + + +---------- + + +.. _user-qmmm: + +USER-QMMM package +--------------------------------- + +.. note:: + + The LAMMPS executable these steps produce is not yet functional + for a QM/MM simulation. You must also build Quantum ESPRESSO and + create a new executable (pwqmmm.x) which links LAMMPS and Quantum + ESPRESSO together. These are steps 3 and 4 described in the + lib/qmmm/README file. Unfortunately, the Quantum ESPRESSO developers + have been breaking the interface that the QM/MM code in LAMMPS is using, + so that currently (Summer 2018) using this feature requires either + correcting the library interface feature in recent Quantum ESPRESSO + releases, or using an outdated version of QE. The last version of + Quantum ESPRESSO known to work with this QM/MM interface was version + 5.4.1 from 2016. + +**CMake build**\ : + +The CMake build system currently does not support building the full +QM/MM-capable hybrid executable of LAMMPS and QE called pwqmmm.x. +You must use the traditional make build for this package. + +**Traditional make**\ : + +Before building LAMMPS, you must build the QMMM library in lib/qmmm. +You can do this manually if you prefer; follow the first two steps +explained in lib/qmmm/README. You can also do it in one step from the +lammps/src dir, using a command like these, which simply invoke the +lib/qmmm/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-qmmm # print help message + make lib-qmmm args="-m serial" # build with GNU Fortran compiler (settings as in "make serial") + make lib-qmmm args="-m mpi" # build with default MPI compiler (settings as in "make mpi") + make lib-qmmm args="-m gfortran" # build with GNU Fortran compiler + +The build should produce two files: lib/qmmm/libqmmm.a and +lib/qmmm/Makefile.lammps. The latter is copied from an existing +Makefile.lammps.\* and has settings needed to build LAMMPS with the +QMMM library (though typically the settings are just blank). If +necessary, you can edit/create a new lib/qmmm/Makefile.machine file +for your system, which should define an EXTRAMAKE variable to specify +a corresponding Makefile.lammps.machine file. + +You can then install QMMM package and build LAMMPS in the usual +manner. After completing the LAMMPS build and compiling Quantum +ESPRESSO with external library support, go back to the lib/qmmm folder +and follow the instructions on the README file to build the combined +LAMMPS/QE QM/MM executable (pwqmmm.x) in the lib/qmmm folder. + + +---------- + + +.. _user-quip: + +USER-QUIP package +--------------------------------- + +To build with this package, you must download and build the QUIP +library. It can be obtained from GitHub. For support of GAP +potentials, additional files with specific licensing conditions need +to be downloaded and configured. See step 1 and step 1.1 in the +lib/quip/README file for details on how to do this. + +**CMake build**\ : + + +.. parsed-literal:: + + -D QUIP_LIBRARIES=path # path to libquip.a (only needed if a custom location) + +CMake will not download and build the QUIP library. But once you have +done that, a CMake build of LAMMPS with "-D PKG\_USER-QUIP=yes" should +work. Set QUIP\_LIBRARIES if CMake cannot find the QUIP library. + +**Traditional make**\ : + +The download/build procedure for the QUIP library, described in +lib/quip/README file requires setting two environment variables, +QUIP\_ROOT and QUIP\_ARCH. These are accessed by the +lib/quip/Makefile.lammps file which is used when you compile and link +LAMMPS with this package. You should only need to edit +Makefile.lammps if the LAMMPS build can not use its settings to +successfully build on your system. + + +---------- + + +.. _user-scafacos: + +USER-SCAFACOS package +----------------------------------------- + +To build with this package, you must download and build the `ScaFaCoS Coulomb solver library `_ + +.. _scafacos-home: http://www.scafacos.de + + + +**CMake build**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_SCAFACOS=value # download ScaFaCoS for build, value = no (default) or yes + -D SCAFACOS_LIBRARY=path # ScaFaCos library file (only needed if at custom location) + -D SCAFACOS_INCLUDE_DIR=path # ScaFaCoS include directory (only needed if at custom location) + +If DOWNLOAD\_SCAFACOS is set, the ScaFaCoS library will be downloaded +and built inside the CMake build directory. If the ScaFaCoS library +is already on your system (in a location CMake cannot find it), +SCAFACOS\_LIBRARY is the filename (plus path) of the ScaFaCoS library +file, not the directory the library file is in. SCAFACOS\_INCLUDE\_DIR +is the directory the ScaFaCoS include file is in. + +**Traditional make**\ : + +You can download and build the ScaFaCoS library manually if you +prefer; follow the instructions in lib/scafacos/README. You can also +do it in one step from the lammps/src dir, using a command like these, +which simply invoke the lib/scafacos/Install.py script with the +specified args: + +make lib-scafacos # print help message +make lib-scafacos args="-b" # download and build in lib/scafacos/scafacos- +make lib-scafacos args="-p $HOME/scafacos # use existing ScaFaCoS installation in $HOME/scafacos + +Note that 2 symbolic (soft) links, "includelink" and "liblink", are +created in lib/scafacos to point to the ScaFaCoS src dir. When LAMMPS +builds in src it will use these links. You should not need to edit +the lib/scafacos/Makefile.lammps file. + + +---------- + + +.. _user-smd: + +USER-SMD package +------------------------------- + +To build with this package, you must download the Eigen3 library. +Eigen3 is a template library, so you do not need to build it. + +**CMake build**\ : + + +.. parsed-literal:: + + -D DOWNLOAD_EIGEN3 # download Eigen3, value = no (default) or yes + -D EIGEN3_INCLUDE_DIR=path # path to Eigen library (only needed if a custom location) + +If DOWNLOAD\_EIGEN3 is set, the Eigen3 library will be downloaded and +inside the CMake build directory. If the Eigen3 library is already on +your system (in a location CMake cannot find it), EIGEN3\_INCLUDE\_DIR +is the directory the Eigen3++ include file is in. + +**Traditional make**\ : + +You can download the Eigen3 library manually if you prefer; follow the +instructions in lib/smd/README. You can also do it in one step from +the lammps/src dir, using a command like these, which simply invoke +the lib/smd/Install.py script with the specified args: + + +.. parsed-literal:: + + make lib-smd # print help message + make lib-smd args="-b" # download to lib/smd/eigen3 + make lib-smd args="-p /usr/include/eigen3" # use existing Eigen installation in /usr/include/eigen3 + +Note that a symbolic (soft) link named "includelink" is created in +lib/smd to point to the Eigen dir. When LAMMPS builds it will use +this link. You should not need to edit the lib/smd/Makefile.lammps +file. + + +---------- + + +.. _user-vtk: + +USER-VTK package +------------------------------- + +To build with this package you must have the VTK library installed on +your system. + +**CMake build**\ : + +No additional settings are needed besides "-D PKG\_USER-VTK=yes". + +This should auto-detect the VTK library if it is installed on your +system at standard locations. Several advanced VTK options exist if +you need to specify where it was installed. Use the ccmake (terminal +window) or cmake-gui (graphical) tools to see these options and set +them interactively from their user interfaces. + +**Traditional make**\ : + +The lib/vtk/Makefile.lammps file has settings for accessing VTK files +and its library, which LAMMPS needs to build with this package. If +the settings are not valid for your system, check if one of the other +lib/vtk/Makefile.lammps.\* files is compatible and copy it to +Makefile.lammps. If none of the provided files work, you will need to +edit the Makefile.lammps file. See lib/vtk/README for details. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_link.rst b/doc/rst/Build_link.rst new file mode 100644 index 0000000000..8306fcb86f --- /dev/null +++ b/doc/rst/Build_link.rst @@ -0,0 +1,91 @@ +Link LAMMPS as a library to another code +======================================== + +LAMMPS can be used as a library by another application, including +Python scripts. The files src/library.cpp and library.h define the +C-style API for using LAMMPS as a library. See the :doc:`Howto library ` doc page for a description of the +interface and how to extend it for your needs. + +The :doc:`Build basics ` doc page explains how to build +LAMMPS as either a shared or static library. This results in one of +these 2 files: + +liblammps.so # shared library +liblammps.a # static library + + +---------- + + +**Link with LAMMPS as a static library**\ : + +The calling application can link to LAMMPS as a static library with a +link command like this: + +g++ caller.o -L/home/sjplimp/lammps/src -llammps -o caller + +The -L argument is the path to where the liblammps.a file is. The +-llammps argument is shorthand for the file liblammps.a. + + +---------- + + +**Link with LAMMPS as a shared library**\ : + +If you wish to link to liblammps.so, the operating system finds shared +libraries to load at run-time using the environment variable +LD\_LIBRARY\_PATH. To enable this you can do one of two things: + +(1) Copy the liblammps.so file to a location the system can find it, +such as /usr/local/lib. I.e. a directory already listed in your +LD\_LIBRARY\_PATH variable. You can type + + +.. parsed-literal:: + + printenv LD_LIBRARY_PATH + +to see what directories are in that list. + +(2) Add the LAMMPS src directory (or the directory you perform CMake +build in) to your LD\_LIBRARY\_PATH, so that the current version of the +shared library is always available to programs that use it. + +For the csh or tcsh shells, you would add something like this to your +~/.cshrc file: + + +.. parsed-literal:: + + setenv LD_LIBRARY_PATH ${LD_LIBRARY_PATH}:/home/sjplimp/lammps/src + + +---------- + + +**Calling the LAMMPS library**\ : + +Either flavor of library (static or shared) allows one or more LAMMPS +objects to be instantiated from the calling program. + +When used from a C++ program, all of LAMMPS is wrapped in a LAMMPS\_NS +namespace; you can safely use any of its classes and methods from +within the calling code, as needed. + +When used from a C or Fortran program, the library has a simple +C-style interface, provided in src/library.cpp and src/library.h. + +See the :doc:`Python library ` doc page for a +description of the Python interface to LAMMPS, which wraps the C-style +interface. + +See the sample codes in examples/COUPLE/simple for examples of C++ and +C and Fortran codes that invoke LAMMPS through its library interface. +Other examples in the COUPLE directory use coupling ideas discussed on +the :doc:`Howto couple ` doc page. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_make.rst b/doc/rst/Build_make.rst new file mode 100644 index 0000000000..8f1966f101 --- /dev/null +++ b/doc/rst/Build_make.rst @@ -0,0 +1,94 @@ +Build LAMMPS with make +====================== + +Building LAMMPS with traditional makefiles requires that you have a +Makefile."machine" file appropriate for your system in the src/MAKE, +src/MAKE/MACHINES, src/MAKE/OPTIONS, or src/MAKE/MINE directory (see +below). It can include various options for customizing your LAMMPS +build with a number of global compilation options and features. + +To include LAMMPS packages (i.e. optional commands and styles) you +must install them first, as discussed on the :doc:`Build package ` doc page. If the packages require +provided or external libraries, you must build those libraries before +building LAMMPS. Building :doc:`LAMMPS with CMake ` can +automate all of this for many types of machines, especially +workstations, desktops and laptops, so we suggest you try it first. + +These commands perform a default LAMMPS build, producing the LAMMPS +executable lmp\_serial or lmp\_mpi in lammps/src: + + +.. parsed-literal:: + + cd lammps/src + make serial # build a serial LAMMPS executable + make mpi # build a parallel LAMMPS executable with MPI + make # see a variety of make options + +This initial compilation can take a long time, since LAMMPS is a large +project with many features. If your machine has multiple CPU cores +(most do these days), using a command like "make -jN mpi" (with N = +the number of available CPU cores) can be much faster. If you plan to +do development on LAMMPS or need to re-compile LAMMPS repeatedly, the +installation of the ccache (= Compiler Cache) software may speed up +compilation even more. + +After the initial build, whenever you edit LAMMPS source files, or add +or remove new files to the source directory (e.g. by installing or +uninstalling packages), you must re-compile and relink the LAMMPS +executable with the same "make" command. This makefiles dependencies +should insure that only the subset of files that need to be are +re-compiled. + +.. note:: + + When you build LAMMPS for the first time, a long list of \*.d + files will be printed out rapidly. This is not an error; it is the + Makefile doing its normal creation of dependencies. + + +---------- + + +The lammps/src/MAKE tree contains all the Makefile.machine files +included in the LAMMPS distribution. Typing "make machine" uses +Makefile.machine. Thus the "make serial" or "make mpi" lines above +use Makefile.serial and Makefile.mpi. Others are in these dirs: + + +.. parsed-literal:: + + OPTIONS # Makefiles which enable specific options + MACHINES # Makefiles for specific machines + MINE # customized Makefiles you create (you may need to create this folder) + +Typing "make" lists all the available Makefile.machine files. A file +with the same name can appear in multiple folders (not a good idea). +The order the dirs are searched is as follows: src/MAKE/MINE, +src/MAKE, src/MAKE/OPTIONS, src/MAKE/MACHINES. This gives preference +to a customized file you put in src/MAKE/MINE. + +Makefiles you may wish to try include these (some require a package +first be installed). Many of these include specific compiler flags +for optimized performance. Please note, however, that some of these +customized machine Makefile are contributed by users. Since both +compilers, OS configurations, and LAMMPS itself keep changing, their +settings may become outdated: + + +.. parsed-literal:: + + make mac # build serial LAMMPS on a Mac + make mac_mpi # build parallel LAMMPS on a Mac + make intel_cpu # build with the USER-INTEL package optimized for CPUs + make knl # build with the USER-INTEL package optimized for KNLs + make opt # build with the OPT package optimized for CPUs + make omp # build with the USER-OMP package optimized for OpenMP + make kokkos_omp # build with the KOKKOS package for OpenMP + make kokkos_cuda_mpi # build with the KOKKOS package for GPUs + make kokkos_phi # build with the KOKKOS package for KNLs + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_package.rst b/doc/rst/Build_package.rst new file mode 100644 index 0000000000..9f56f3f329 --- /dev/null +++ b/doc/rst/Build_package.rst @@ -0,0 +1,265 @@ +Include packages in build +========================= + +In LAMMPS, a package is a group of files that enable a specific set of +features. For example, force fields for molecular systems or +rigid-body constraints are in packages. In the src directory, each +package is a sub-directory with the package name in capital letters. + +An overview of packages is given on the :doc:`Packages ` doc +page. Brief overviews of each package are on the :doc:`Packages details ` doc page. + +When building LAMMPS, you can choose to include or exclude each +package. In general there is no need to include a package if you +never plan to use its features. + +If you get a run-time error that a LAMMPS command or style is +"Unknown", it is often because the command is contained in a package, +and your build did not include that package. Running LAMMPS with the +:doc:`-h command-line switch ` will print all the included +packages and commands for that executable. + +For the majority of packages, if you follow the single step below to +include it, you can then build LAMMPS exactly the same as you would +without any packages installed. A few packages may require additional +steps, as explained on the :doc:`Build extras ` doc page. + +These links take you to the extra instructions for those select +packages: + ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`COMPRESS ` | :ref:`GPU ` | :ref:`KIM ` | :ref:`KOKKOS ` | :ref:`LATTE ` | :ref:`MESSAGE ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`MSCG ` | :ref:`OPT ` | :ref:`POEMS ` | :ref:`PYTHON ` | :ref:`VORONOI ` | :ref:`USER-ADIOS ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-ATC ` | :ref:`USER-AWPMD ` | :ref:`USER-COLVARS ` | :ref:`USER-H5MD ` | :ref:`USER-INTEL ` | :ref:`USER-MOLFILE ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-NETCDF ` | :ref:`USER-PLUMED ` | :ref:`USER-OMP ` | :ref:`USER-QMMM ` | :ref:`USER-QUIP ` | :ref:`USER-SCAFACOS ` | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ +| :ref:`USER-SMD ` | :ref:`USER-VTK ` | | | | | ++----------------------------------+----------------------------------+------------------------------------+------------------------------+--------------------------------+--------------------------------------+ + +The mechanism for including packages is simple but different for CMake +versus make. + +**CMake variables**\ : + + +.. parsed-literal:: + + -D PKG_NAME=value # yes or no (default) + +Examples: + + +.. parsed-literal:: + + -D PKG_MANYBODY=yes + -D PKG_USER-INTEL=yes + +All standard and user packages are included the same way. Note that +USER packages have a hyphen between USER and the rest of the package +name, not an underscore. + +See the shortcut section below for how to install many packages at +once with CMake. + +.. note:: + + If you toggle back and forth between building with CMake vs + make, no packages in the src directory can be installed when you + invoke cmake. CMake will give an error if that is not the case, + indicating how you can un-install all packages in the src dir. + +**Traditional make**\ : + + +.. parsed-literal:: + + cd lammps/src + make ps # check which packages are currently installed + make yes-name # install a package with name + make no-name # un-install a package with name + make mpi # build LAMMPS with whatever packages are now installed + +Examples: + + +.. parsed-literal:: + + make no-rigid + make yes-user-intel + +All standard and user packages are included the same way. + +See the shortcut section below for how to install many packages at +once with make. + +.. note:: + + You must always re-build LAMMPS (via make) after installing or + un-installing a package, for the action to take effect. + +.. note:: + + You cannot install or un-install packages and build LAMMPS in a + single make command with multiple targets, e.g. make yes-colloid mpi. + This is because the make procedure creates a list of source files that + will be out-of-date for the build if the package configuration changes + within the same command. You can include or exclude multiple packages + in a single make command, e.g. make yes-colloid no-manybody. + +**CMake and make info**\ : + +Any package can be included or excluded in a LAMMPS build, independent +of all other packages. However, some packages include files derived +from files in other packages. LAMMPS checks for this and does the +right thing. Individual files are only included if their dependencies +are already included. Likewise, if a package is excluded, other files +dependent on that package are also excluded. + +When you download a LAMMPS tarball or download LAMMPS source files +from the Git or SVN repositories, no packages are pre-installed in the +src directory. + +.. note:: + + Prior to Aug 2018, if you downloaded a tarball, 3 packages + (KSPACE, MANYBODY, MOLECULE) were pre-installed in the src directory. + That is no longer the case, so that CMake will build as-is without the + need to un-install those packages. + + +---------- + + +**CMake shortcuts for installing many packages**\ : + +Instead of specifying all the CMake options via the command-line, +CMake allows initializing the variable cache using script files. These +are regular CMake files which can manipulate and set variables, and +can also contain control flow constructs. + +LAMMPS includes several of these files to define configuration +"presets", similar to the options that exist for the Make based +system. Using these files you can enable/disable portions of the +available packages in LAMMPS. If you need a custom preset you can take +one of them as a starting point and customize it to your needs. + ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/all\_on.cmake [OPTIONS] ../cmake | enable all packages | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/all\_off.cmake [OPTIONS] ../cmake | disable all packages | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/minimal.cmake [OPTIONS] ../cmake | enable just a few core packages | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/most.cmake [OPTIONS] ../cmake | enable most common packages | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/nolib.cmake [OPTIONS] ../cmake | disable packages that do require extra libraries or tools | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/clang.cmake [OPTIONS] ../cmake | change settings to use the Clang compilers by default | ++-------------------------------------------------------------+-----------------------------------------------------------+ +| cmake -C ../cmake/presets/mingw.cmake [OPTIONS] ../cmake | enable all packages compatible with MinGW compilers | ++-------------------------------------------------------------+-----------------------------------------------------------+ + +.. note:: + + Running cmake this way manipulates the variable cache in your + current build directory. You can combine multiple presets and options + in a single cmake run, or change settings incrementally by running + cmake with new flags. + +**Example:** + + +.. parsed-literal:: + + # build LAMMPS with most commonly used packages, but then remove + # those requiring additional library or tools, but still enable + # GPU package and configure it for using CUDA. You can run. + mkdir build + cd build + cmake -C ../cmake/presets/most.cmake -C ../cmake/presets/nolib.cmake -D PKG_GPU=on -D GPU_API=cuda ../cmake + + # to add another package, say BODY to the previous configuration you can run: + cmake -D PKG_BODY=on . + + # to reset the package selection from above to the default of no packages + # but leaving all other settings untouched. You can run: + cmake -C ../cmake/presets/no_all.cmake . + + +---------- + + +**Make shortcuts for installing many packages**\ : + +The following commands are useful for managing package source files +and their installation when building LAMMPS via traditional make. +Just type "make" in lammps/src to see a one-line summary. + +These commands install/un-install sets of packages: + ++-----------------------------------+-----------------------------------------------------+ +| make yes-all | install all packages | ++-----------------------------------+-----------------------------------------------------+ +| make no-all | un-install all packages | ++-----------------------------------+-----------------------------------------------------+ +| make yes-standard or make yes-std | install standard packages | ++-----------------------------------+-----------------------------------------------------+ +| make no-standard or make no-std | un-install standard packages | ++-----------------------------------+-----------------------------------------------------+ +| make yes-user | install user packages | ++-----------------------------------+-----------------------------------------------------+ +| make no-user | un-install user packages | ++-----------------------------------+-----------------------------------------------------+ +| make yes-lib | install packages that require extra libraries | ++-----------------------------------+-----------------------------------------------------+ +| make no-lib | un-install packages that require extra libraries | ++-----------------------------------+-----------------------------------------------------+ +| make yes-ext | install packages that require external libraries | ++-----------------------------------+-----------------------------------------------------+ +| make no-ext | un-install packages that require external libraries | ++-----------------------------------+-----------------------------------------------------+ + +which install/un-install various sets of packages. Typing "make +package" will list all the these commands. + +.. note:: + + Installing or un-installing a package works by simply copying + files back and forth between the main src directory and + sub-directories with the package name (e.g. src/KSPACE, src/USER-ATC), + so that the files are included or excluded when LAMMPS is built. + +The following make commands help manage files that exist in both the +src directory and in package sub-directories. You do not normally +need to use these commands unless you are editing LAMMPS files or are +:doc:`installing a patch ` downloaded from the LAMMPS web +site. + +Type "make package-status" or "make ps" to show which packages are +currently installed. For those that are installed, it will list any +files that are different in the src directory and package +sub-directory. + +Type "make package-installed" or "make pi" to show which packages are +currently installed, without listing the status of packages that are +not installed. + +Type "make package-update" or "make pu" to overwrite src files with +files from the package sub-directories if the package is installed. +It should be used after a :doc:`patch has been applied `, +since patches only update the files in the package sub-directory, but +not the src files. + +Type "make package-overwrite" to overwrite files in the package +sub-directories with src files. + +Type "make package-diff" to list all differences between pairs of +files in both the src dir and a package dir. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_settings.rst b/doc/rst/Build_settings.rst new file mode 100644 index 0000000000..e80afd482f --- /dev/null +++ b/doc/rst/Build_settings.rst @@ -0,0 +1,437 @@ +Optional build settings +======================= + +LAMMPS can be built with several optional settings. Each sub-section +explain how to do this for building both with CMake and make. + +| :ref:`FFT library ` for use with the :doc:`kspace\_style pppm ` command +| :ref:`Size of LAMMPS data types ` +| :ref:`Read or write compressed files ` +| :ref:`Output of JPG and PNG files ` via the :doc:`dump image ` command +| :ref:`Output of movie files ` via the :doc:`dump\_movie ` command +| :ref:`Memory allocation alignment ` +| :ref:`Workaround for long long integers ` +| :ref:`Error handling exceptions ` when using LAMMPS as a library +| + + +---------- + + +.. _fft: + +FFT library +--------------------- + +When the KSPACE package is included in a LAMMPS build, the +:doc:`kspace\_style pppm ` command performs 3d FFTs which +require use of an FFT library to compute 1d FFTs. The KISS FFT +library is included with LAMMPS but other libraries can be faster. +LAMMPS can use them if they are available on your system. + +**CMake variables**\ : + + +.. parsed-literal:: + + -D FFT=value # FFTW3 or MKL or KISS, default is FFTW3 if found, else KISS + -D FFT_SINGLE=value # yes or no (default), no = double precision + -D FFT_PACK=value # array (default) or pointer or memcpy + +.. note:: + + The values for the FFT variable must be in upper-case. This is + an exception to the rule that all CMake variables can be specified + with lower-case values. + +Usually these settings are all that is needed. If CMake cannot find +the FFT library, you can set these variables: + + +.. parsed-literal:: + + -D FFTW3_INCLUDE_DIRS=path # path to FFTW3 include files + -D FFTW3_LIBRARIES=path # path to FFTW3 libraries + -D MKL_INCLUDE_DIRS=path # ditto for Intel MKL library + -D MKL_LIBRARIES=path + +**Makefile.machine settings**\ : + + +.. parsed-literal:: + + FFT_INC = -DFFT_FFTW3 # -DFFT_FFTW3, -DFFT_FFTW (same as -DFFT_FFTW3), -DFFT_MKL, or -DFFT_KISS + # default is KISS if not specified + FFT_INC = -DFFT_SINGLE # do not specify for double precision + FFT_INC = -DFFT_PACK_ARRAY # or -DFFT_PACK_POINTER or -DFFT_PACK_MEMCPY + +# default is FFT\_PACK\_ARRAY if not specified + + +.. parsed-literal:: + + FFT_INC = -I/usr/local/include + FFT_PATH = -L/usr/local/lib + FFT_LIB = -lfftw3 # FFTW3 double precision + FFT_LIB = -lfftw3 -lfftw3f # FFTW3 single precision + FFT_LIB = -lmkl_intel_lp64 -lmkl_sequential -lmkl_core # MKL with Intel compiler + FFT_LIB = -lmkl_gf_lp64 -lmkl_sequential -lmkl_core # MKL with GNU compier + +As with CMake, you do not need to set paths in FFT\_INC or FFT\_PATH, if +make can find the FFT header and library files. You must specify +FFT\_LIB with the appropriate FFT libraries to include in the link. + +**CMake and make info**\ : + +The `KISS FFT library `_ is included in the LAMMPS +distribution. It is portable across all platforms. Depending on the +size of the FFTs and the number of processors used, the other +libraries listed here can be faster. + +However, note that long-range Coulombics are only a portion of the +per-timestep CPU cost, FFTs are only a portion of long-range +Coulombics, and 1d FFTs are only a portion of the FFT cost (parallel +communication can be costly). A breakdown of these timings is printed +to the screen at the end of a run using the :doc:`kspace\_style pppm ` command. The :doc:`Run output ` +doc page gives more details. + +FFTW is a fast, portable FFT library that should also work on any +platform and can be faster than the KISS FFT library. You can +download it from `www.fftw.org `_. LAMMPS requires +version 3.X; the legacy version 2.1.X is no longer supported. + +Building FFTW for your box should be as simple as ./configure; make; +make install. The install command typically requires root privileges +(e.g. invoke it via sudo), unless you specify a local directory with +the "--prefix" option of configure. Type "./configure --help" to see +various options. + +The Intel MKL math library is part of the Intel compiler suite. It +can be used with the Intel or GNU compiler (see FFT\_LIB setting above). + +Performing 3d FFTs in parallel can be time consuming due to data +access and required communication. This cost can be reduced by +performing single-precision FFTs instead of double precision. Single +precision means the real and imaginary parts of a complex datum are +4-byte floats. Double precision means they are 8-byte doubles. Note +that Fourier transform and related PPPM operations are somewhat less +sensitive to floating point truncation errors and thus the resulting +error is less than the difference in precision. Using the -DFFT\_SINGLE +setting trades off a little accuracy for reduced memory use and +parallel communication costs for transposing 3d FFT data. + +When using -DFFT\_SINGLE with FFTW3 you may need to build the FFTW +library a second time with support for single-precision. + +For FFTW3, do the following, which should produce the additional +library libfftw3f.a + + +.. parsed-literal:: + + make clean + ./configure --enable-single; make; make install + +Performing 3d FFTs requires communication to transpose the 3d FFT +grid. The data packing/unpacking for this can be done in one of 3 +modes (ARRAY, POINTER, MEMCPY) as set by the FFT\_PACK syntax above. +Depending on the machine, the size of the FFT grid, the number of +processors used, one option may be slightly faster. The default is +ARRAY mode. + + +---------- + + +.. _size: + +Size of LAMMPS data types +------------------------------------ + +LAMMPS has a few integer data types which can be defined as 4-byte or +8-byte integers. The default setting of "smallbig" is almost always +adequate. + +**CMake variable**\ : + + +.. parsed-literal:: + + -D LAMMPS_SIZES=value # smallbig (default) or bigbig or smallsmall + +**Makefile.machine setting**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_SMALLBIG # or -DLAMMPS_BIGBIG or -DLAMMPS_SMALLSMALL + +# default is LAMMPS\_SMALLBIG if not specified +**CMake and make info**\ : + +The default "smallbig" setting allows for simulations with: + +* total atom count = 2\^63 atoms (about 9e18) +* total timesteps = 2\^63 (about 9e18) +* atom IDs = 2\^31 (about 2 billion) +* image flags = roll over at 512 + +The "bigbig" setting increases the latter two limits. It allows for: + +* total atom count = 2\^63 atoms (about 9e18) +* total timesteps = 2\^63 (about 9e18) +* atom IDs = 2\^63 (about 9e18) +* image flags = roll over at about 1 million (2\^20) + +The "smallsmall" setting is only needed if your machine does not +support 8-byte integers. It allows for: + +* total atom count = 2\^31 atoms (about 2 billion) +* total timesteps = 2\^31 (about 2 billion) +* atom IDs = 2\^31 (about 2 billion) +* image flags = roll over at 512 (2\^9) + +Atom IDs are not required for atomic systems which do not store bond +topology information, though IDs are enabled by default. The +:doc:`atom\_modify id no ` command will turn them off. Atom +IDs are required for molecular systems with bond topology (bonds, +angles, dihedrals, etc). Thus if you model a molecular system with +more than 2 billion atoms, you need the "bigbig" setting. + +Image flags store 3 values per atom which count the number of times an +atom has moved through the periodic box in each dimension. See the +:doc:`dump ` doc page for a discussion. If an atom moves through +the periodic box more than this limit, the value will "roll over", +e.g. from 511 to -512, which can cause diagnostics like the +mean-squared displacement, as calculated by the :doc:`compute msd ` command, to be faulty. + +Note that the USER-ATC package and the USER-INTEL package are currently +not compatible with the "bigbig" setting. Also, there are limitations +when using the library interface. Some functions with known issues +have been replaced by dummy calls printing a corresponding error rather +than crashing randomly or corrupting data. + +Also note that the GPU package requires its lib/gpu library to be +compiled with the same size setting, or the link will fail. A CMake +build does this automatically. When building with make, the setting +in whichever lib/gpu/Makefile is used must be the same as above. + + +---------- + + +.. _graphics: + +Output of JPG, PNG, and movie files +-------------------------------------------------- + +The :doc:`dump image ` command has options to output JPEG or +PNG image files. Likewise the :doc:`dump movie ` command +outputs movie files in MPEG format. Using these options requires the +following settings: + +**CMake variables**\ : + + +.. parsed-literal:: + + -D WITH_JPEG=value # yes or no + # default = yes if CMake finds JPEG files, else no + -D WITH_PNG=value # yes or no + # default = yes if CMake finds PNG and ZLIB files, else no + -D WITH_FFMPEG=value # yes or no + # default = yes if CMake can find ffmpeg, else no + +Usually these settings are all that is needed. If CMake cannot find +the graphics header, library, executable files, you can set these +variables: + + +.. parsed-literal:: + + -D JPEG_INCLUDE_DIR=path # path to jpeglib.h header file + -D JPEG_LIBRARIES=path # path to libjpeg.a (.so) file + -D PNG_INCLUDE_DIR=path # path to png.h header file + -D PNG_LIBRARIES=path # path to libpng.a (.so) file + -D ZLIB_INCLUDE_DIR=path # path to zlib.h header file + -D ZLIB_LIBRARIES=path # path to libz.a (.so) file + -D FFMPEG_EXECUTABLE=path # path to ffmpeg executable + +**Makefile.machine settings**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_JPEG + LMP_INC = -DLAMMPS_PNG + LMP_INC = -DLAMMPS_FFMPEG + + JPG_INC = -I/usr/local/include # path to jpeglib.h, png.h, zlib.h header files if make cannot find them + JPG_PATH = -L/usr/lib # paths to libjpeg.a, libpng.a, libz.a (.so) files if make cannot find them + JPG_LIB = -ljpeg -lpng -lz # library names + +As with CMake, you do not need to set JPG\_INC or JPG\_PATH, if make can +find the graphics header and library files. You must specify JPG\_LIB +with a list of graphics libraries to include in the link. You must +insure ffmpeg is in a directory where LAMMPS can find it at runtime, +i.e. a dir in your PATH environment variable. + +**CMake and make info**\ : + +Using ffmpeg to output movie files requires that your machine +supports the "popen" function in the standard runtime library. + +.. note:: + + On some clusters with high-speed networks, using the fork() + library calls (required by popen()) can interfere with the fast + communication library and lead to simulations using ffmpeg to hang or + crash. + + +---------- + + +.. _gzip: + +Read or write compressed files +----------------------------------------- + +If this option is enabled, large files can be read or written with +gzip compression by several LAMMPS commands, including +:doc:`read\_data `, :doc:`rerun `, and :doc:`dump `. + +**CMake variables**\ : + + +.. parsed-literal:: + + -D WITH_GZIP=value # yes or no + # default is yes if CMake can find gzip, else no + -D GZIP_EXECUTABLE=path # path to gzip executable if CMake cannot find it + +**Makefile.machine setting**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_GZIP + +**CMake and make info**\ : + +This option requires that your machine supports the "popen()" function +in the standard runtime library and that a gzip executable can be +found by LAMMPS during a run. + +.. note:: + + On some clusters with high-speed networks, using the fork() + library calls (required by popen()) can interfere with the fast + communication library and lead to simulations using compressed output + or input to hang or crash. For selected operations, compressed file + I/O is also available using a compression library instead, which is + what the :ref:`COMPRESS package ` enables. + + +---------- + + +.. _align: + +Memory allocation alignment +--------------------------------------- + +This setting enables the use of the posix\_memalign() call instead of +malloc() when LAMMPS allocates large chunks or memory. This can make +vector instructions on CPUs more efficient, if dynamically allocated +memory is aligned on larger-than-default byte boundaries. +On most current systems, the malloc() implementation returns +pointers that are aligned to 16-byte boundaries. Using SSE vector +instructions efficiently, however, requires memory blocks being +aligned on 64-byte boundaries. + +**CMake variable**\ : + + +.. parsed-literal:: + + -D LAMMPS_MEMALIGN=value # 0, 8, 16, 32, 64 (default) + +Use a LAMMPS\_MEMALIGN value of 0 to disable using posix\_memalign() +and revert to using the malloc() C-library function instead. When +compiling LAMMPS for Windows systems, malloc() will always be used +and this setting ignored. + +**Makefile.machine setting**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_MEMALIGN=value # 8, 16, 32, 64 + +Do not set -DLAMMPS\_MEMALIGN, if you want to have memory allocated +with the malloc() function call instead. -DLAMMPS\_MEMALIGN **cannot** +be used on Windows, as it does use different function calls for +allocating aligned memory, that are not compatible with how LAMMPS +manages its dynamical memory. + + +---------- + + +.. _longlong: + +Workaround for long long integers +------------------------------------------------ + +If your system or MPI version does not recognize "long long" data +types, the following setting will be needed. It converts "long long" +to a "long" data type, which should be the desired 8-byte integer on +those systems: + +**CMake variable**\ : + + +.. parsed-literal:: + + -D LAMMPS_LONGLONG_TO_LONG=value # yes or no (default) + +**Makefile.machine setting**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_LONGLONG_TO_LONG + + +---------- + + +.. _exceptions: + +Exception handling when using LAMMPS as a library +------------------------------------------------------------------ + +This setting is useful when external codes drive LAMMPS as a library. +With this option enabled LAMMPS errors do not kill the caller. +Instead, the call stack is unwound and control returns to the caller, +e.g. to Python. + +**CMake variable**\ : + + +.. parsed-literal:: + + -D LAMMPS_EXCEPTIONS=value # yes or no (default) + +**Makefile.machine setting**\ : + + +.. parsed-literal:: + + LMP_INC = -DLAMMPS_EXCEPTIONS + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Build_windows.rst b/doc/rst/Build_windows.rst new file mode 100644 index 0000000000..fd96b37983 --- /dev/null +++ b/doc/rst/Build_windows.rst @@ -0,0 +1,111 @@ +Notes for building LAMMPS on Windows +==================================== + +* :ref:`General remarks ` +* :ref:`Running Linux on Windows ` +* :ref:`Using GNU GCC ported to Windows ` +* :ref:`Using a cross-compiler ` + + +---------- + + +.. _generic: + +General remarks +----------------------------- + +LAMMPS is developed and tested primarily on Linux machines. The vast +majority of HPC clusters and supercomputers today runs on Linux as well. +Thus portability to other platforms is desired, but not always achieved. +The LAMMPS developers strongly rely on LAMMPS users giving feedback and +providing assistance in resolving portability issues. This particularly +true for compiling LAMMPS on Windows, since this platform has significant +differences with some low-level functionality. + +.. _linux: + +Running Linux on Windows +------------------------------------ + +So before trying to build LAMMPS on Windows, please consider if using +the pre-compiled Windows binary packages are sufficient for your needs +(as an aside, those packages themselves are build on a Linux machine +using cross-compilers). If it is necessary for your to compile LAMMPS +on a Windows machine (e.g. because it is your main desktop), please also +consider using a virtual machine software and run a Linux virtual machine, +or - if have a recently updated Windows 10 installation - consider using +the Windows subsystem for Linux, which allows to run a bash shell from +Ubuntu and from there on, you can pretty much use that shell like you +are running on an Ubuntu Linux machine (e.g. installing software via +apt-get). For more details on that, please see :doc:`this tutorial ` + +.. _gnu: + +Using GNU GCC ported to Windows +----------------------------------------- + +One option for compiling LAMMPS on Windows natively, that has been known +to work in the past is to install a bash shell, unix shell utilities, +perl, GNU make, and a GNU compiler ported to Windows. The Cygwin package +provides a unix/linux interface to low-level Windows functions, so LAMMPS +can be compiled on Windows. The necessary (minor) modifications to LAMMPS +are included, but may not always up-to-date for recently added functionality +and the corresponding new code. A machine makefile for using cygwin for +the old build system is provided. Using CMake for this mode of compilation +is untested and not likely to work. + +When compiling for Windows do **not** set the -DLAMMPS\_MEMALIGN define +in the LMP\_INC makefile variable and add -lwsock32 -lpsapi to the linker +flags in LIB makefile variable. Try adding -static-libgcc or -static or +both to the linker flags when your resulting LAMMPS Windows executable +complains about missing .dll files. The CMake configuration should set +this up automatically, but is untested. + +In case of problems, you are recommended to contact somebody with +experience in using cygwin. If you do come across portability problems +requiring changes to the LAMMPS source code, or figure out corrections +yourself, please report them on the lammps-users mailing list, or file +them as an issue or pull request on the LAMMPS GitHub project. + +.. _cross: + +Using a cross-compiler +---------------------------------- + +If you need to provide custom LAMMPS binaries for Windows, but do not +need to do the compilation on Windows, please consider using a Linux +to Windows cross-compiler. This is how currently the Windows binary +packages are created by the LAMMPS developers. Because of that, this is +probably the currently best tested and supported way to build LAMMPS +executables for Windows. There are makefiles provided for the +traditional build system, but CMake has also been successfully tested +using the mingw32-cmake and mingw64-cmake wrappers that are bundled +with the cross-compiler environment on Fedora machines. A CMake preset +selecting all packages compatible with this cross-compilation build +is provided. You likely need to disable the GPU package unless you +download and install the contents of the pre-compiled `OpenCL ICD loader library `_ +into your MinGW64 cross-compiler environment. The cross-compilation +currently will only produce non-MPI serial binaries. + +Please keep in mind, though, that this only applies to compiling LAMMPS. +Whether the resulting binaries do work correctly is no tested by the +LAMMPS developers. We instead rely on the feedback of the users +of these pre-compiled LAMMPS packages for Windows. We will try to resolve +issues to the best of our abilities if we become aware of them. However +this is subject to time constraints and focus on HPC platforms. + +.. _native: + +Native Visual C++ support +-------------------------------------- + +Support for the Visual C++ compilers is currently not available. The +CMake build system is capable of creating suitable a Visual Studio +style build environment, but the LAMMPS code itself is not fully ported +to support Visual C++. Volunteers to take on this task are welcome. + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Commands.rst b/doc/rst/Commands.rst new file mode 100644 index 0000000000..e845faa903 --- /dev/null +++ b/doc/rst/Commands.rst @@ -0,0 +1,34 @@ +Commands +******** + +These pages describe how a LAMMPS input script is formatted and the +commands in it are used to define a LAMMPS simulation. + + +.. toctree:: + :maxdepth: 1 + + Commands_input + Commands_parse + Commands_structure + Commands_category + +.. toctree:: + :maxdepth: 1 + + Commands_all + Commands_fix + Commands_compute + Commands_pair + Commands_bond + Commands_kspace + +.. toctree:: + :maxdepth: 1 + + Commands_removed + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/rst/Commands_all.rst b/doc/rst/Commands_all.rst new file mode 100644 index 0000000000..fcd6cdd689 --- /dev/null +++ b/doc/rst/Commands_all.rst @@ -0,0 +1,59 @@ ++----------------------------------------+------------------------------------+------------------------------------------+ +| :doc:`General commands ` | :doc:`Fix styles ` | :doc:`Compute styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ +| :doc:`Pair styles ` | :doc:`Bond styles ` | :ref:`Angle styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ +| :ref:`Dihedral styles ` | :ref:`Improper styles ` | :doc:`KSpace styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ + +General commands +================ + +An alphabetic list of all general LAMMPS commands. + ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`angle\_coeff ` | :doc:`angle\_style ` | :doc:`atom\_modify ` | :doc:`atom\_style ` | :doc:`balance ` | :doc:`bond\_coeff ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`bond\_style ` | :doc:`bond\_write ` | :doc:`boundary ` | :doc:`box ` | :doc:`change\_box ` | :doc:`clear ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`comm\_modify ` | :doc:`comm\_style ` | :doc:`compute ` | :doc:`compute\_modify ` | :doc:`create\_atoms ` | :doc:`create\_bonds ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`create\_box ` | :doc:`delete\_atoms ` | :doc:`delete\_bonds ` | :doc:`dielectric ` | :doc:`dihedral\_coeff ` | :doc:`dihedral\_style ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`dimension ` | :doc:`displace\_atoms ` | :doc:`dump ` | :doc:`dump adios ` | :doc:`dump image ` | :doc:`dump movie ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`dump netcdf ` | :doc:`dump netcdf/mpiio ` | :doc:`dump vtk ` | :doc:`dump\_modify ` | :doc:`dynamical\_matrix ` | :doc:`echo ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`fix ` | :doc:`fix\_modify ` | :doc:`group ` | :doc:`group2ndx ` | :doc:`hyper ` | :doc:`if ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`info ` | :doc:`improper\_coeff ` | :doc:`improper\_style ` | :doc:`include ` | :doc:`jump ` | :doc:`kim\_init ` | ++-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ +| :doc:`kim\_interactions ` | :doc:`kim\_query ` | :doc:`kspace\_modify ` | :doc:`kspace\_style ` | :doc:`label

txt2html - a text to HTML conversion tool -

-

txt2html is a simple tool for converting text files into HTML files. -Text files can contain simple formatting and mark-up commands that -txt2html converts into HTML. -

-

txt2html was written by Steve Plimpton. I use it for -documentation and WWW pages. Anna Reese added the table -formatting options. -

-

See the example.txt and example.html -files in the txt2html directory for examples of what all the -formatting commands and mark-up syntax end up looking like in HTML. -

- - - - - - -
- -

Syntax: -

-
txt2html file -
read from text file, write HTML to standard output -
txt2html file1 file2 file3 ... -
read each argument as text file, write one HTML file per argument -
-

Input files are first opened with the specified name. If that fails, -a ".txt" suffix is added. Output files are created with an ".html" -suffix, which is either added or replaces the ".txt" suffix. -

-
- -

Compiling: -

-

The source for txt2html is a single C++ file. Compile it by typing: -

-
g++ -o txt2html txt2html.cpp 
-
-
- -

How the tool works: -

-

txt2html reads a text file, one paragraph at a time. A paragraph -ends with: -

-
  • a blank line -
  • a line whose final word starts with ":" (a format string) -
  • the end of the file -
-

Any line in the paragraph which ends with "\" is concatenated to the -following line by removing the "\" character and following newline. -This can be useful for some of the formatting commands described below -that operate on individual lines in the paragraph. -

-

If a paragraph starts with a "<" character and ends with a ">" -character, it is treated as raw HTML and is written directly into the -output file. -

-

If a paragraph does not end with a format string, then it is -surrounded with HTML paragraph markers (<P> and </P>), -mark-up is performed, and the paragraph is written to the -output file. -

-

If the paragraph ends with a format string, then formatting -is performed, mark-up is performed, and the paragraph is -written to the output file. -

-
- -Formatting: - -

A format string is the last word of a paragraph if it starts with a -":" character. A format string contains one or more comma-separated -commands, like ":ulb,l" or ":c,h3". Note that a format string cannot -contain spaces, else it would not be the last word. An individual -command can have 0 or more arguments: -

-
  • b or line() = 0 arguments -
  • image(file) = 1 argument -
  • link(alias,value) = 2 or more comma-separated arguments -
-

Format commands add HTML markers at the beginning or end of the -paragraph and individual lines. Commands are processed in the order -they appear in the format string. Thus if two commands add HTML -markers to the beginning of the paragraph, the 2nd command's marker -will appear 2nd. The reverse is true at the end of the paragraph; the -2nd command's marker will appear 1st. Some comands, like line or -image make most sense if used as stand-alone commands without an -accompanying paragraph. -

-

Commands that format the entire paragraph: -

-
  • p --> surround the paragraph with <P> </P> -
  • b --> put <BR> at the end of the paragraph -
  • pre --> surround the paragraph with <PRE> </PRE> -
  • c --> surround the paragraph with <CENTER> </CENTER> -
  • h1,h2,h3,h4,h5,h6 --> surround the paragraph with <H1> </H1>, etc -
-

Commands that format the lines of the paragraph as a list: -

-
  • ul --> surround the paragraph with <UL> </UL>, put <LI> at start of every line -
  • ol --> surround the paragraph with <OL> </OL>, put <LI> at start of every line -
  • dl --> surround the paragraph with <DL> </DL>, alternate <DT> and <DD> at start of every line -
-

Commands that treat the paragraph as one entry in a list: -

-
  • l --> put <LI> at the beginning of the paragraph -
  • dt --> put <DT> at the beginning of the paragraph -
  • dd --> put <DD> at the beginning of the paragraph -
  • ulb --> put <UL> at the beginning of the paragraph -
  • ule --> put </UL> at the end of the paragraph -
  • olb --> put <OL> at the beginning of the paragraph -
  • ole --> put </OL> at the end of the paragraph -
  • dlb --> put <DL> at the beginning of the paragraph -
  • dle --> put </DL> at the end of the paragraph -
-

Commands applied to each line of the paragraph: -

-
  • all(p) --> surround each line with <P> </P> -
  • all(c) --> surround each line with <CENTER> </CENTER> -
  • all(b) --> append a <BR> to each line -
  • all(l) --> prepend a <LI> to each line -
-

Special commands (all HTML is inserted at beginning of paragraph): -

-
  • line --> insert a horizontal line = <HR> -
  • image(file) --> insert an image = <IMG SRC = "file"> -
  • image(file,link) --> insert an image that when clicked on goes to link -
  • link(name) --> insert a named link that can be referred to elsewhere (see mark-up) = <A NAME = "name"></A> -
  • link(alias,value) --> define a link alias that can be used elsewhere in this file (see mark-up) -
-

Table command: -

-
  • tb(c=3,b=5,w=100%,a=c) --> format the paragraph as a table -
-

Arguments within tb() can appear in any order and are all optional, -since they each have default values. -

-
  • c=N --> Make an N-column table. Treat the paragraph as one - long list of entries (separated by the separator character) and put - them into N columns one after the other. If N = 0, treat each line - of the paragraph as one row of the table with as many columns as - there are maximum entries in any line. Default is c=0. - -
  • s=: --> Use the character string following the equal sign as - the separator between entries. Default separator is a comma "," which - you cannot specify directly since the comma delimits the tb() arguments - -
  • b=N --> Create a border N pixels wide. If N is 0, there is no - border between or outside the cells. If N is 1, there is a minimal - border between and outside all cells. For N > 1, the border between - cells does not change but the outside border gets wider. Default is - b=1. - -
  • w=N or w=N% --> The first form makes each cell of the table at - least N pixels wide. The second form makes the entire table take up - N% of the width of the browser window. Default is w=0 which means - each cell will be just as wide as the text it contains. - -
  • a=X --> Align the entire table at the left, center, or right of the - browser window, for X = "l", "c", or "r". Default is a=c. - -
  • ea=X --> Align the text in each entry at the left, center, or - right of its cell, for X = "l", "c", or "r". Default is browser's - default (typically left). - -
  • eva=X --> Vertically align the text in each entry at the - top, middle, baseline, or bottom of its cell, for X = "t", "m", "ba", - or "bo". Default is browser's default (typically middle). - -
  • cwM=N or cwM=N% --> The first form makes column M be at least - N pixels wide. The second form makes column M take up N% of the - width of the browser window. This setting overrides the "w" - argument for column M. Only one column per table can be tweaked - with this argument. Default is no settings for any column. - -
  • caM=X --> Align the text in each entry of column M at the left, - center, or right of its cell, for X = "l", "c", or "r". This - setting overrides the "ea" argument for column M. Only one column - per table can be tweaked with this argument. Default is no settings - for any column. - -
  • cvaM=X --> Vertically align the text in each entry of column m - at the top, middle, baseline, or bottom of its cell, for X = "t", - "m", "ba", or "bo". This setting overrides the "eva" argument for - column M. Only one column per table can be tweaked with this - argument. Default is no settings for any column. -
-
- -Mark-up: - -

The text of the paragraph is scanned for special mark-up characters -which are converted into HTML. -

-

Bold and italic characters: -

-
  • "[" (left brace) --> turn-on bold by inserting a <B> -
  • "]" (right brace) --> turn-off bold by inserting a </B> -
  • "{" (left bracket) --> turn-on italics by inserting a <I> -
  • "}" (right bracket) --> turn-off italics by - inserting a </I>
- -

If a backspace '\' precedes any of the bold/italic mark-up characters, -then mark-up is not performed; the mark-up character is simply left in -the text. -

-

Links are inserted by enclosing a section of text in double quotes, -and appending an underscore to the ending quote, followed by the link. -The link ends when whitespace is found, except that trailing -punctuation characters (comma, period, semi-colon, colon, question -mark, exclamation point, parenthesis) are not considered part of the -link. -

-

A link of the form "text"_link becomes <A HREF = -"link">text</A> in the HTML output. The only exception is if -"link" is defined elsewhere in the file as an alias (see the link -command above). In that case, the value is used instead of the alias -name.

- -

With these rules, links can take several forms. -

-
  • "This links"_#abc to another part of this file which is -labeled with a :link(abc) command.
    -
  • "This links"_other.html to another file named other.html.
    -
  • "This links"_other.html#abc to another file which has an "abc" -location defined internally.
    -
  • "This links"_http://www.google.com to a WWW site.
    -
  • "This"_M12 could be used in place of any of the above forms. It -requires an alias like :link(M12,http://www.google.com) to be defined -elsewhere in the file.
- - diff --git a/doc/utils/txt2html/txt2html b/doc/utils/txt2html/txt2html deleted file mode 100755 index 023631eac1b472cdcaf4e8c4757c72c386446ecf..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 68760 zcmeFad3;n=(l>rO$%TMGf&&PM(jp)rOIQuE*Z~?k8ZZxwGH#ua1c+uc>0n%NA|Xf< zq8SDp#4Rc+cvr%s(Z=bn4+?VH~@(`LrlY|8w^sHuv$+CC13^tV#YaX}r2N>-heL-kkvR0n7o z_-E=lypQqEuh-Gf(bOx#LpqxRf)g68}wVwvWuwzxg7cAL9T=yn~3E z!QVkD)vNS>d$Q@cW}{Z9+34T{lU^l?CN<0b56Y3Bzx0zRigTsDXmJ@L{+rb7hf#UC zizbX4m6tstFSnqyY(!b|gb@?QjVvh~IfmO!_DOfvoCREy8Am%f^0^28Q4Wy&-Ma5r zJ$cj9X^9(_eYED9elPdEIpYnIrQo00Z{@Lb)i_&XEMYV7ZzlddH0bv?c6jdEf}v-v z?U%kT{`-kvSM?j>d^_#N)axV*pcMA`D;zmJ3?nul6-L58hXaxDnNjrr0b7yu=R~QO z;$+9a@K1jL_HYpVefSs2{;g5)XQTLebrk%!QQA8KoffIy-cjsKjAG|V6hEt?*olo& z@AXme^eA=)MbYma1s@fqzrK&suCZvB9sj~Vv!du%M5*`eDEOr?Y!5dMek=Y(>KAtu z|1XMyAB^H>V-$Q)6gvx|_*DUS46=G6?2eGOuKO7ThUzn(XK? zi*pOI-EhX^E?n$Pza)z+WM`(c!n~5AG{U6pIMOwB$k@1&+?#UP);v#9UTPL<9-Xx` zv)Jt^&dl|cq-HtiW#Y>@Z&B)e_xvRH{LyX{pEuS$_mX)N5RWV7%qy8OnhdzJ$}-)> zIqbCQX>oXU<2AxA&Y9;)&MhoK150wor55CRv>mcIA+x9`M>`5rzuYr+YF@JVHGMR- z6d1KYT)H5uFuy3XILD01ypqg$<}rnX9Y&E73L-p#lsIO{3~WkVbIY8p1L=gkoPs5u zrGYNdR&*mtTvCdhDt6|J%?Y^$B{{_&XMV6>MvvuAT%22M?L`jhBIH$pJ1f(ZwUn~4 ztjt}MQ(RJ5keQe3xzW8WN&9JunCaE%3oJGZ3a!~ua6`B&W+UP5xa>?%rnHipY<3Go zqbIOQ&b1JW>?wN8^pipt3>A({`}0aJD9%Cam*sHu=6S{>nTf80=*}rFE-aSFgl9<5 zq}g7vo1JH-`}mw<4A`<hjysN zHx%b$SZ8_)bJgOa;@kqyV$#nqTt+IzRL<=t2V{cD&&)+t#W^`@*7WJ_u_KezthCf= z)7@i6ju|;#O<%Y$Wm>9x^vJOqUbqk{<7noJvHTax$3hav(paqfWAKl@G5N`HXjv^Y zHAy=tCzLG3i4D><@K66|14{o$P9GcodmF{gb$0sT8&9Jv$kkfR@~HH}eCj$}A;zhDAt#%jq3du;h*6J;{_&j|q{i2b9r;Lqndbw#ymVS{^Sna% zbPL|QA%i)xLG_y-y9KA{nV%sRJk|t3lPtKn$kJpBPIa3fhXuD@Pr59)wO#2J9Dxgb z7FzJm0aU3B3yzKme3n}9E&)`jA`9Ntf|ptFZWg@Uf+tw;)fSxk&HU6@@a`rEy3vAL z*K4&F{5KZ;Ef$=vZOu=e1@CEspxZ5YFALsa!OyVZ`z?5H3*KbG`&jU13r^R{=BLGi zpJ{@iJ`0{=!P_jjxfes?;}-lZi@w^G!5rlXUBjB6cnfYfLC{1CevSq2ZNUdvaJvOR z*MbkR-~%mqk_8`R!ILfcU<>ZB;OALzmjxeU!P71HPz%1$f)BIc85aC}3%=BX54Ye& z7JP&SFSFpIEO@yEPqN^vE%;~)USq+>Sn!P&oUU!nPpt*#DPIIzEckd+8MMxVPq5(I zE%*f%yupGeTk!oBe4+(!vfvk5@Ma4>%YwI9@JSZjXTc|1@HPuR#eyHV;8QKQ+MU51 z<^M$%Jl=vkEV!%Uvv^mPk^i_|xhfkxhVNzwT@`!d_h_Z|@rxj8AC!&ng#Hd35xe@so$T@{OQEgl<#*i-l ze@#41>3+rh5#nho_qY8FV9>|J(-iJ+Vg4ZTG3%)d-LP1XK7=64fM zQ?$R9`5na5)axl15yo32Q z#M4ykPhx%r@idkC?abdqJWZkgMCOZ$Kbv^P{I$f>RO)a0iQ2!2csube%wIt~O`ZNG z=I0VWfcOUHFD9O*N`D>m(}<@j(qGH`g~Zd;=&xaZ4DmE2`pcOgMm$Z0{vzfF5I=io%z#=rzy|xV7@c)=M$gAd<^k4#rf^b|F8u-O>O=}=D#L>B=L&*BgE4b z=Wjc~{ZBkiZT=SK4-!vPn!kzpH;AXH%-_KL%f!ZqK|D=a{u<_= zCZ47$e>wAy6Hil=zliyVh^MK^pTYbl;%Q3qr!&8fc$$j*4(8VoPg9LQiTM@8(-h;k zGk+8DG`08>nJ*@urWC&dKl<}j?}2Mv-j7`shuYHTr#3d!taB(=<1Ras#_GNf0Pnp2Zg0BUe=~|C^jH28P_mJ7dCFxe3sUCK zbKUk?vP~)P3tKS^T;6AEiBwn8q~P*4`p*54*)|q7`g&-#MOZ_#O~M}gft4GC{ZzAc z!Zw4g;A(88Gcg&*!+n=`*A5zl^>9J$tV6JU2M}dQk36cSLj%$#lKvIaouusRgSs1? z&)`rsI_rqI8l77-yO}inh4`*=Zgy>SRrh$26{;$^c?fxxs{ety7EP>0|5rAYc7ZW2 zHty8Lev)FjTr8n-CoESv>na*-){2~4T;6xc`svghuXBrbgtQ_#Lz*rMCMkHG4KNsH zt-4=~tIF9xiXVPYCSy-&F;OgZk%q$`+kUiKym}RNRXFQx70%7JR_ctKABor*Gtfv# zuNG-oXAFi^cg9+{M7E-bJ7JreJR)Ib9+Ck{RU0VXhVJ$@RUEe^RNjXeHacIW@K-rs zb!9cXIE|HRNpMZvb3mwSS4(VbM^|G5GLuuY`FMMKs&{Xyx8K0o)p-Nsp#*;4 zZ10z?iD}+;-%^rSG{&b^d|^wi__@9GNNV*AsCk{+t13C$H~+5S%e@@)AH3ZCT~sd{owcZ1wN9siEvQA-M$Tl&Tv>0ps=K^R>aMB< z+g-MoF@?Ci@A~G!e1)?X9aB5W`RXmtHahPmCI3}eYBV}G(s846J(1SARnGO+8YpEj zP3~7**qxz#m!;zbz}OtCaNm2Z3sC068S+y-+r7grfKJY>g2glf?w&Ocuz+U0)?7Alsn zj!CFofg@Nq=f;Pz{PH?iRykMFsLg7E$j#2d%2c3{;$YXAL^#<)DSJES%++2+& zsDusZp@hnj+TWPg-AIXWEBY8}uGWED9NRHL(o zeDYr&M{%oBp26ZVpWy2I=>Yp~gep#*?VgU?DP39(4mlF&JTVZZo#!A({vWZ@CflW< zwugxAvrc83YKvm~MdX720kQ3|N6~tKv~Gk}NV`T$-4F7xa5l6iyQ*e4m?|+;srNPN zs0>Otokcn#X2~T|(p9m%p}llhh|V~%{#T@u*I6zym*jvc?RgZ^%3G*=t1CHw!jj|= zXJRF1SeWP~h^kNNrEmg~A2eIszb^8W@BGhB%N7np;* zm1UIA{H@#T;E?HY>ph@XVo-K+jg?6(ttO=%lh_&V$Y(Dh%Nw-R+Q3_Nlvw~PmwvgH^F*#-eLdz1&PejlM13fSeE<;(zEpjn+kjXt+#x$_`R2g|+cFT+qw^)}9~{M<7%&D-W0y2s^h z<~106POZMmP-zoegHE1-f~}vYd4Ejve(Jjz{`sFn7=MLRpm=Mb!#u!}U7F4&EPov*PB!E!8Riv;^03udPN6bojCc&G(4 z`Qm#(9CdGaA9=Z(V%Rii_ zUEUY=)8&Wv*#?kC=VvsXHac7IjkEm*mSJ9nte)=pkkO%R-`R}RYgVO+70W+Up3b_T z%W2AGxHF&I`AQ7or1Dhs8Wi<9TW(w4(vC4(Is|L4A2-@zb=MBsA<&~UgT~)pG*(|> z4EwyjeV?-xP8}krT9c}rhg=&IwyiYC>T2h^<;&mg?CFK?PM$=3_rJ9RzJFI5heEi_ zIfT)3Xp*z#mi^_+Tb1W5RJod}tXj}qztKALtV50BYQ1?{ox@F~gfLrhFTBB(N$F|a zY{T!RI7xuaQoTnc9Lmp6ymuQt;){V@E3vO{CFBJ0oN`4Y1E>>(NkCIe#ZW%-Q`{Gb5%Kg=7ehc*+MmWowx{EfPYS3pxKR| zv7ilI+18G8JNb$$uqtO8PFyc>{^$*a8k%`uxP`72z0cD2jmx`XDU<39BGr{Od==d2 zd+P|ZMZ%sr1FdRw`p7bx#zn)HG}E+qO>m;Ay|nY+N!9-%Hv0Te;0r#ZOrX9$yKY9uZWY^>DWSb`Tq9O@c};@eP8*>eYzg`bc0>hH(8VO zTa?nn;Y=OKItk=0D1-#(1;u_>^#;bPD|MWCu`-52U0rDw_&b#kZ+gSYO`om}>s69A z$1Sg7a~rsX4z8D4gfoVCbOkD)VTVcr@!&Xz^vE;Nq8=HlGdSK=;q=*RT9^9wQwoRs z*L1Rf5BsRr4J--injfeyFe1gBS176$SEOqyIBQix`^ikts+=u2;bSw8FM2O$kT00;(x#_{mm9|_jlR!5 zg}a;tAO8VKpw>HR&edz9HpEOPK`%7E!r5Z0GJ34HtBKB*gtaAf)~T*+k!EMZPL**C zHYhc)eXv1G#G|vOajQ-3M>&|4ZBqC=F8rLOu$Ju8SMDt-T-emk)rCXCkVEzn2Ezj* zmPpKIoFg%p5>cXuh*C3sBh6w{0>yZ*pjWUM<$slNmiEnS^uPfozD>A+0An@O73b-g z`D`eJUhIP*MsrgAaKSqvBmB9R0;5IHgm$687_-1w!JDapRh2ZO?YIC~ptGMsoc#SQ zmL^MyRbiGKg5P1WG}CG+hb+C_E7*wHQetwLrAq~$VX?H(YUxa}RAsTWNJ@O|2yI=C z;6I>%*}7}3mJS?-r4);$A}O&Y%uCM0uE{KMTIvVyVt*$xW7C$90OC%G;#G1Z|0~W;hGCTT2b4Qg>TQy&$FN2B~!b z>=Hblf=IXM%xd7an5o`)8pf)&oE_;Xy#8?U#BFGIZ5HI-kRN%nr!IpOwL9#9|QzAmA zm9jk<%9n_iBO`cnGy8TpjF?#x(tWYi;1Y}VM6rGl_sY=VldM0jEwOd8OJ9Q#(|Sm+ zJ@PTE_q165jaa`WiuL&x>t;_DS*(Y2)-1CAx9-8nm?!G9**Z?iiuRNa;f6vvju5Ai zlTq^|U^u5@>kW&G`d;GNohS?}gHC$Y)g;<6fJMA)I)Gb_Qi9G*D?cKw4Xms~F3a_M z$Z4?xy{n+-?_zOvsMJ;hC$I&(@>84XYGnjhM+96=Bv(gC;X?#hSEg%MNwi~f(AB}( zRf5UY_gdIhRt|Bs4Pi8`K<_Wm^Uu@nV2?W$N05d@?*0pb@dYu%(BRa*onZ=S26=gr zcsW(PBtNRFNo4i1Jeln~v^1Thx_KP#MOvDqrL5#VDEp>cw9Kw$q++!@MC|I=kkXDz zg0bmrDT_A0@F9nQs{#9@W_5Lqz6Uf*zEL1+G@BvpZOm?PP(>ke-N?C7$pRGnE%f}I z61cTBP_9px_!Oa^CD%4SEoRM)bOS5IcBRXlc?-GDeKX`n3~^$Z8Xk= z3HsF2YGLQb-Ix=u`WFf`R`_raF=C(g54c_nIfkSg zw3LUxgnAAlU>1YJ{dH<^1z;03OBGRbY+zfj`!!wv;aIaFP4Fn#kR{DrErFDRJk#uv zal%-mZ@sit>aGOq-`Ig0$w`nW4Zjyv{MwP>3b@r0;#SkU>=uFK7Ej>AwObl%^!)_S z{fQPo3dN5e{|i4Fs9SixYYXwirTrj~{NOXkX5AMWYxI?pAFGXEJW9lmwXpeXK4c1T`dDt;as zErW$iA-f)iB^oTWAfkzu1|{9tucZvoRg zFA(aj4?d^XaIe!|GMj`AMSg*9N7dd~2<+U_M&Dy^lkw|K;}|+xvQM9XGm^NyrnaA4 z`4wl1m#8>*dlKpkj*9=`T7SIF^qSB0_i|nOR;S+X+oT5%l_lq|<3PNKQaCqxjpwO& zu!*xF^=HJgzYZ!9sehW^A_3oXsV|fMnSpvk?!?5xQl$Q=iQGRcVYA9urrmOF4D^rM zgH^@V==>_c&||^zlZ=W{hUE1(OaE*}z52p{Yi{&q!4mb)R2Z|4pYq84 zbLb6fOfT)0rGFgMs231{D&za#nJr~7ozs@a51T~O8eoH(Sca;pfA9~04S346(9^cA>IF5@A-U*(Dn-ss z;XdrIo%0&Ks9>-`{UL1~51>W5=Ys>(Lb@gJ)^fY5FW14}j?PiOkI`zq8yrt@(7WrL z=YbV(0&2#J_wVQus>Zas9r_hN+DdIT70&l@d+hy5&O-@nA3REKRwnX72+x0_YRh%S zGkBsH^Lj7QsDD)Q;Ik&Uytw`euzG^73R8Sa6!(zglzQ4`(Ta=06t{`uCQ|GXUe8LP z2x2Y98hKd%f@r@CE6`Qsb@lAp9WOD?tB!6|Ji42tA z(Sow|)WK9@4wtCp5@6do2)eOg+cazT*hiXWw;_E)v*ak5;`lE^sA|abAH?&2Ax7xd zp|p8Yx)9PLlA6^&KoP{)Dc^&!^AMuK$w>ytV#@18DLF5=8Of>ca*)qDIh|0}$$1@V z(fyoB&ZdM_PHg*_=}1+Po%0bQq@$Kf#4mGBNSy4P%LJEdI6=(Vy|8zRv>y@sU zIE+gCKgXGHoxraX{AmDg5O_PmO#!$`;0FnQE&#U(yoTV10&ttaB?MOmV8x3i?Eet# z3BVbm?Iif>li-mA&kVqcV&n{hM+M+?F`@{j7i#Fno3Q^iz_tKv7b9-~ZaqV*I>bUf zVe*JWlIT4iLGLb$on{{i^)0Nf=uH5q>~_fQZCxRC-_hRt`Ybq zg8vbK&5OA#s&ZQZt`+SxXt&POhU)}NCQN#vL9l@qtWNw&Busj+N%T&r;^vGjxmGf$6q0}DFmtfe`slJv55jY=~0dcx9m1w6lJ5Fif*nNxNeVbX^tmQ0v9 zVj3H0!4jo{L-72QEk`c>qzAjCuRzLR2G0(xcJ9PO6h7q{!snOjbkmruyZ%S3 zO};Ap7QSboF5of?>_9chdtNpC9i{w_5MMPL&xdI5Eb@CGFJHd%%2GT@6jT_=p0j~X zh)(Mgs9YVYGA5{U1F6h_%FUrF7X(%2lgc?zSzdakwW3KumC@7`^v3PZ!yE91ONwLTw-3XWD+h7`Dr-wvV8sww(yu zt%j>2zXcDQENGEN2C~gYRp7}le!`@*87-`1PloPxd2wY=y-!QIbo?+!Kf_z~tl74i zR6iarq0pJbfcJavBb%a*X`z5y$IlV9xU6<5miSqMe%?B0_lp}_ILvVk{66Dd&6?-1 z{hB4$XfA(FcLG~GsiBjp=Oc}lJrsf9sCpGAkSb$SkzL{EFDv)bk7|t7;OK+)mdj-L zuRR>MB4J+xYq>jfANO3s%I-EU@nbepw+#VS{xPW+P5| z6s{pHY@kzgt2eN*AH>)Qcmqs}d3)Iem8A~q4VJF}DQtloMJw>D z7u1s>N)=#rD0zQ!uASPGu<}|R$|TXcnzUm6h-*&P`r@oWC`qF}4ic(yFx31{QYhmC zy1T=4JB#iQ_;rsCd-s6uU0RpI&USl zM62kD^>c(qhy6D?9K3Wwh^aMMVr&~Kp#WSFe8 zRDcjsyrp>*F%MYoBkGSpAAQikN<}&sibzx-PMxEj%FrV2#cJzM3-+*EmFXzs!p&oH z+Hx&FT}!z%YClFH(mPV*%%@-*oz3V!Jecm3-vnm6M&A`2e&>Gw7MvCvoqLf`baveDb-qPUHYZe$0#e~@#%aS@j;DzAB>eBL zR286<0!2k*HgE?io=An%OvOi(oWPU|I=6jRv9l|#}nHfn`u2* zHJcu%q!&{9uAWgl44_x--uNiD@1B2a^zZ^pxTm2nZg zz$V@#XLIQVRmN!c$uk12b!7!SD(3v+m6si@u5i9}8d8D$^bf{2I;kemNscZAU}MgV z6nD}~+z`D#cOM)IwSQ~SeglNCZ-_#q?)eES0qc#vZeY24Y)zCtoHP;B@!{X-h_#kl zVqsmD4n*6kjFHz;x0DVGbJteZI!xI%l?kpcb=tq&tP#|^y21|W*1O#+G1s+<`Zt`0M*O3y<;)h2!ynAJ02lS-OxCHW_R^Jp`;b zI$y%%h^5g8DNt`d25bwKs;9?*slLyj!(!kQc&FEET&Xv#y!puPF6hE0)mpz$%0EHn zAExs3h=Z;_RhJ)T)^9#3bDO0+JpfAe=L5s`JMXG<*XWzA z*&4~TshX`7c9dr8gtcq7LD=qK{nt|F^0uV8Yw`oZ-2-rwXn(RD@L`&CSi42wR|$SS z0JjPJEMRkcNTEUG`hylMQLt(YW*6*6GD*MU)iosvyvU;JkZR_T>gSXhdXHCBFR-Z6 z@|0>n*McQU@dPTqDNsB^RF5O%=AK%*s2(Cr_Pcob36o8P;oUBD&(PF+p0JA<)623y z6EH{vyiK@?0NFRJCC|JBh-uSIsRhdr7cwnakzlheSh-*m3A;$UWfyD^VX}3o1nX`o zn<&^%+k(E-2!9 z9KY=<;~vn<_9`8}NzY<9(Ct48)oWnzt3j<6gZZD2s_2KV36-z%3_(j|C*sP}N+IZKb_jRXwMW z3EYb1I3@aDq){Tbe&6^jic@>!cW%15jlRC*Gi@wLKo3$i6}~vE$$k3AQJFB&< z>V@F1)E^*|)p$2d_3Wk{b;0oU)E6VbX;sVNJ478#s%Y_c-H;|a-iqVa3m|FXKCl>R z(u?I5i;)MkkrpagqK)v7xd49Dn~%l4%Z~d<~%tOJ^+sAF<75Iy}rV#kkiEZnUU!tG5v#W1L&_ zh(&{|TOTxbHyOKaFO3Atz@XpM(vN2`ki5_CrQw8GUnZze|H7;}u{IN1Rms0>gL5xw zX`2ke9bo16p#CNptuh)A61=PK+$!g1mgiH_6ChKQDygpUC0@eHTRGG8ek1D0fzd#5 z`yQ-k-$ZxvI)UQ@21^{;Qfh&@`X(KJ-`ObUe;N%9E&E3*YmV{9by-@Ia@n_~?8kM8 zDIQrBpSjX&s37fRQKi?16*M0q_!AX$gcckGT`Kc0$aJ2(c@^@c#hNG7-#Sk^>WC&$ z`0+zGYSEb+b*1DjJmqs&bv0>N_d-7FL{jtpEQ#EGJY1fo?w4Y4W0j=>us3LyDk3MB zg5~8j83^o!yzvxWihYLP=(WN1iO$aw)}Dg`@}pOO7tFI&M$fCwuJ*|uFZERp#&7hl zrprS3)+DvxgnDS*#aqM~RNRLJH*b28b3cNSuBH-!Ew8aC=Kq4b+FEuim8DHED!VhR zthojD-IIYdv6d~Ova~5iWh-=9N)xWv+!Fgc%2JwG3tm74X_Jf!UL01?+#*{+1(7D! zfzSai~s*^B&kkqufZ zyUd&>cj!c50o-sSre+0T(=}^$R0>#56Gdr~EeZPPCn!yPNRv)iQkwV@*8ZDTr~C~6 z>fPwhiD;y3)wWR&nkBDC$<_kYR|I=INHy>{?lYX%`gI(7m(7~>$2w4B^)qAgwitbq z*jdN^XHXR2e~pe8nJ4x(u=49!|L-|*@H>2ZJfwlV{0kyz=Bz$#oNuh-l=F%h7 zUR+l=YXW|DVLx$Bte#zC^>99W$h&FOWI2b~**$&QKZ?eiCleos5I^)crv8>fh=-ZD z33S%fZ&RvYEYZG)pW~)8ro1s~HqHmU1w(@hEe>cUmx?S=zJX0hLmn+qwh?X1#V?@(QKmh!B1N; z@^WkxNm|v~1wIVeT%slk_J##BXR3NC-h{r>#T}yhm_;>Rus>KZGlPFe#i{FcaWhYr zT2zaq_^1n^)0 zGyA2{w=aOnttgaz+Jc$ky&sq?haaZEiv@XuM&OMK4!lvJ*<1RS%e!Dd?_FVa=4`H~ zpE8hFLtw>=wGH-+@isneR%$T@2#dX3iL;H$kh=eI)TD2P(jstw6;A$TBe31krpg9u z0OM?uv+Z}?0vz7j&^i@d8&;0TTgL^8g=+L;4Xh)VcMj;r4JJ6G?)0RHGtm}a)DbEtY^cP5?TP`y6cknMJ4`*BGJM(eTSEM_-ta>G>Rk+MXugcLvN^|tmK-x zCX81+;TFtSt7IxB;s}zeMC~L`%Z~$1^&YWBx_$CA%W2USUBU0K)cHeiwb5yZ zs*oMx+q;{oyQxKJTcdA3v3Lj2bW{E}0C*v(DNm;U4JOM_uxWU~uzq9aV<-5fvmr0c zLt7Fpk6~4OmW(Df!-FO|!@w+Pqi+*R%0>ZXSdTpnp5APNHHTCy_9jb)hm6gTaW)xUqhlG8J>CWH!vrVK zHPm@0C(kT`skcLt=W;^np?kBunLPBy^W?(p2X;vUn&zro^v|7EBLo-G^UO zD6d*oykm;>yAc|xDZtn)w?H#V3LY|RlLsL#?JA@+RS z2i56#2QjV1c+^eNjc$7>a2^Y-**hB(3;m;kDYF*ZHy{x2Kp$CJ|3impt*7@|MsK~V zDq<_})^Rz&sqi8STr-XQN%L6wE^1|H#us zZk;z#_Zpw2_Ld_&t8tD14cV8kc!4(EaT8ykj-9KK0;rG%4jsl@CYDLOKcBFIABnHh zTeiV1<8$ukc^`G)9mAOEaPGl1aLE4sEI14pxh%H5I8D%5QY^1}NB1t4!|mz(Ki|Bh2Gy`%AkL^nX_Hd6v!z8dIn*$ELYVH?a4kFw4kv&3WqcHe1x+$J&eYlsDBS?D&$M#!4`vwmTV7z=;HsV+ zgRt_hf^;;p;zP0>czd9BqZ1pTE&p-~-2e_pl8y)hvjDZdM}nWU`=~gWH@2W3yT6YZ z@;7M*ke8M|4msxnzbV1ehE*sV7-)QkLdy{Z4%-bR)cq42jh53&pkTZX2^Z=@$;E}p zf0_kg5vL8#d)nO!yy~?n`u>zD+3GI>5AaD_Meo@4!xm&S4p0n{KWYBl7)X6cIq%mK zBIE2PQ)*ElU(%v;vmRb~?KlcOm*K^-ToHOm@yk*Wj zsQK_Yb30$f0&}KUJK#fRm(e+ER|`TD^y3;fenA|F0y z{)U9%<1RR7$~6ZH#D6(|Y^mrcIrzqfD8Jr&P`WDmUto2l4kMDPP5ydcU z^u@7ip+=vtjg!x0-(wc7sYagCV{B(Y{~zUV%>N>P2L~$U_W$Snr2>}xJ%iX_ z{th5ExT6|%6wD2^GCkA^{ZV_1m0y^@vr+0l5WGr_qwX&jb0z`FkCvbEM9%%-@@-ivLai;twaE zJbPn3EN6r89Wp(ZII|ml>kz|Jjh2(Qc)nc)H_<<(-m2JZ4_+LEown$O_>rA&?afn4aQMD_C%Po$Z1h3olDb^Tt*;tu zH6hXKjV9Af`fX4ncpZWXDv`2)mc|ozmvo?GP9b!Rb@n?RIEzW2G*P>8!qn5X;ky-m z#D-}11GRk+>@%q?%6XsXyOVmbGU#krJU0d;|3CHM0&2;rdT?-{Mm`N#l7%j;PPEeb z!&kN71g?rJoOoK2&L6m|Q0j})Vmgn6-nWe98q9cy^j;Eqhj?}kIuU*@mLBOrnwB2< zY;B-Nusm(_rBz2AMJIdoPh3Gr?u8G{Bx@A*IotK*&D+RmxIWDd3wRr49pLogNoNWa z9Q%>ioAl=o^aV4uqawe_M$yFE_?I`S(zja2lIBou5`~WjDr=8x#j5l#UNjY}Qhyau zo?Ht^HOg%wSn7^JY`rQ+3@tO!c3fJ}r~fbR!S8>0yli~33yl}OiuV@}^)Z3q;KXKbwP!MECyP(b9BaBTL8mmMQ>bUC6YwgX(gW0yx`S4);R4h_W_SL< zj}A&)O&znx=OVf8pnuR|NC$-^7OHI_yOup-dcI@;{l*^k=ferDVJ1Q~+si+Wv{`;! z{q9|IPlr_hjZwXxhjwXGT2&6VD-Z9)&W!T?@FBbAs{E%1+e%o1dhtgKKlD9$J1&&Y zZ0(ckeG#gJd;-NZFK29b?R#%b`YBic;vAvy1v>fEjm3b)+L0RKNrF?yEf>|t`I?vZ zM`-`0*<~XFui*9TzGR9s>C<&_a1X`S6sVU@c*nyh^A36hqT2#@EL;I+qprZNk$p}X z#+L??g|}ud=41(6hgc^K@|&j4qc~`xmbT(ouQY`or74uVkmgZpe(7P7=n$V`zIUQ- z%Nct@sAuPa4W6;F>w40BAJQ9`(;|&gjJp3t_w|SWmhPkXbkN+zmrH9_NpA(WOwga` zD?SrY+}s?)n-Fv1%Ypg1|Otzr_2;u{}_-G$u+K!)9A$ZHHcda`2i$b|kY z(I`AyMSo8ie~#DNo^n~L_gKn;RPWm<^V6ya)t+z1pA4=Zu?2Kq+R%TG{-H;?tg*V5Q&ep?<*M zM3+B-Zlfilc zRcB@I)LG$K;?8PNNoOrcPnqSkPn+vZxrCGfjuI2fId|@*b1$^dgm?C(nI(2lVd03p zLR6M%FYy#ptt0HY1zE*8nI$>)*(nRtQs+3)40Uc3|8kD0~$a152Ol zWR^&lnmpY(XTB3^lSi3H_}ko*U84!1@1fOp?$v3vBz$Q)2Wx)Q_@mr&6%PQn)xZy(wuf> zpLXfo8P2&=l$|qi{tPr={#^PZIVeg&l9`tm%$Jb*vn(}_9DdO`lP(-G6hAGwc{!p^ zJwRWG-sDmE8sHAeqv?gEdD-@YLJvk7e9zDHWG$r}9AIBuSZp8QrnIF7ne7hK&nd_r zQMh;nrKhPmK(`(7e@PA}{Gvj&sLQ53vrJcX8P{Y-4osdu7hyAdgysnx ztC5(j!rBvzOJPwCh0G4WDR3ic(mOeNqJ@Eq;OHy~>6c#>pRCN;!2prl_{co*>+CEO zLumI5wJaygQ&@cAh3?sI%+-1B+=3F!yJovhYCAJ_(pA_@Spy((d3*a794Fq^-d+a! z6KE0k@#1RQ+iO8T!!F={&>8Enm;^loKf$7RPY>DO-kuDa@=AMq2I$l`@pt$@6W?lY zAJPkY@4yb|a8TOs`z>f2XeDSO?EDcl3G`9WEhtCtd8Ruk2SI(HKZC~OK0(I2&;#8K zx)5|oGhV#~+61}N1-%Tk0kjCT z1(e?KuCPEk0XhV<*ZVlhg3|lhmx4Y7S_66*v<~zrXcOq!|3bS!>0SDX7;^=nNuaf$ z>7a)|aUN5hKR|iVaiDdei$R+}H-ol;)`KSEiIlHFlR%TO=1m8^7_^4$Xtxb?Ddw}XBS+6;OwHldG$P66$Wmr!f~b$~tvngMzUv>f#GZxA=oai9&L%RpN| z9|l!;^TuC5?VulnIzV%eqTQe?L05yW1Kk4pDCmCBH$i=%AA!c>6)UG>GjRy$MYO31 zdIc!`S*N9-t3hu8-2&SA7}^b*1KI}qGN`?$Qs03(KnuTv-=Ld8%R!HT)`E^W4!=Pw zL4BaxK;tp4`_ZEepf#X1pb9JfW}^7OJb!FA%~iItMBABNI>y)7IwlfM&*|0N(%wEy ztMGSZeWeD9enuH$g}Fm@OPtxQ_r(dP-4I`{F6ujJ*w}$QZ<5U!_&5JRd;17bmC`M7 zRm}9R9hRbEuq4mMzf8!7g9hYFg7TGs^C3sq1m&}X^38zVkRxS-^3Z~bJqMap z-(LJ{f1^IJuLC$tL^P?;5g|2KLYZ8xHLKTdV70ct9${Ab^9T2JB9oz$d5oyZ4B6V z>+*y>kNUrWd=ZZ0E_pWC9%n^t%)+1^y#sbgljvO;U5|d!xd?hWWbe8#y(@$EjzX^% zdRw3u@QdoaU+WM|@u6pP?Z`Vj0cKu{9qxaT^LR4lIl+3af_xatue6q*MSUMrX4XV; zpeKD-L2omT<8BV~dz03r`nJMe%p1|;`6}ccAb-qSAGPZ~vo_tXqtIIgJ-b!U(yktH zT0X=o&kFi64)QxtK3ZPPhkSJu`9Row2KBFi{CXV6tqp6hWnQ=!c3zEQhvM-(v<9o{iD#iNji`^PBDMGf*bb&%X<{mu@|eggn~(GXwH|kPo$%&kmN)hI}yO zgRSz+pnN6d!%tCuGvpH>A7d?_A1uEYau?*${67SF-YM#j!A?{R1KY4038qAU`hGa>_IE-v{|In{%0{}$wnZHt z0y$lKMT_&jQa)OopNISnl#eEVAM)dnM~m|b$UEa&?mxwOAg=MYLN8jJXF&cmmZL7$3u|c4|%ll9@j;wjgUu*6XnT3$o~|j zJmu>Q$RCD0WF4&6Ica9blAS#0y&1(0$=5>u56CaXabTV;4d&}s$UlWV+I7aOkROFS z+Pw4`dj^vp^diNZ z;&cM?qo?qrANDvthMcdF&Gr4I!8lHa{2j=n#qlc0KRJc{TOdCGd8BrdfA>oL(d<7D zIsM7fXzhC+@*}6H{{-aCkVk4C#rZ18UxoY*igUlPIIj%GVFvbc#(dP?ekJq*eGzjR zD+~v;8Fum^&mlYGEOt_>W7o!27%{SzqT3Y@Gj) zcf`%VsQC|hKggqMTdxY9VVT+bbXodXuy5adtOHUbp0wZb>QKhD_^b zpVqB6^rv-;=Y6L%*s*`o-cIgXKX@1NQ?~OBr7kp@&s3?#-ZRxgqwY+##JKlNwai$3 zrn=AeWZcod>abz_)LZ?jgA2!NI~w(URBOjIv0%KX87KOvji=q!5lrLh#^%1N<#eN_ zulkaYe?EOA@P^+Q+xx25e{&ff_b^)es`q*rul7|wKK`yp4Ox1)H`VuaZ>oA%Z}Ot4 zH#ziSZ}RPn-te;ROnkxT6~i03f!|@Zb#yu0&^RXjv zd`Fz|^h9-ETpo_^GmMues;$NeDzLkw(K1mT=-30t?H!HpCaOE)U+4doFp&1Cgu zZ^Ji9RrfI(CaFL7F*Z(8JNg(~C#jeE7;jBd&3%j$lhmhujLnnPu|CG@lhvJljl+}G z{e91dop1UYKTTHmoVnJvV!C>@pRs<5I?~Vn#Wc0;EXRQqwdQQ&&r{UhXK%ED`Fnq3 z_Y~FK|5_X$up949Q7v{l{@@&=ZHoH*oU?JfeSmTMRJGze)!U4Y|t z1C4`IRoy^i-&FO|K;!ADs+o^JW&GH{OQG}DAmfXv>XSiK_Ul1pxplB{_eJW5!F2r1 zc}CquYQ+#b{&9%Wc#&E&bQq5J3^hJL*`ecbTszEppF_0|Grqk@-EsbG9RGB_;dQ9B z!wnoiKAiMF8E#+$?C5aPZy4eH#-Sbe2Cr zFGW2)-uOO6y)ypdebdyRCm7Y!)ZZo;_fJzz6V85mnmRtg0Dk)g2K4W`z(CDM<>GH??gJS zovw%e;m*bfgVnd4`@K9^-E-Pb+e-u07hQ~J2dbaC7&uf_T_$AbB>r%^sw-QMfI7%)im-w(#XyaC5=_c37UP#*(Tf76HjThaG? z_`1LEw=rK2R*h#7bK)#x(|M}u?7zmXf@AQZM{LF)64YMXm$s+6s#h^_ zbXEV3HE!>!j`DFuoB@1YT!jrW9w86W!FR)985JX-UA}JQ2zj>q4!YU`$bSqwu4R z8EOh-^m_;7Zr9*MjYp_B7qC*|veL+l6Br#*I%?W_vhpX0ENY^=3yjJG{R+DGD@Pjyl+1Qpw3 zd)m5;H)h+iI_ImKt>t^#x{f#I+pg{GQ7gzpZ5WQnCmShh0T3K_u{KKA{NL~YM&Q2@ z_-_RM8-f2u;J*?0e-VLwsU!kfOx62V+51n4WVTEmpT9manxJhlq?Q{L0T z6kAUGS-;M~w2x+0^9vb#bf)mQB7K*a=MRK$Bekl9-MyCb1>d6yy*uX_2KrWiCmZdzyEz);vZhqHtE-W zLf;X3Sm-gK9eO#qXfL6Ig-#GUQ|M(v7Ykh`bd}J%ggz>Co6vni-w}FP=rN%k&XD?r z4i-8==uDxP30*97nb1{2?-Kf`&}~BZ34KTCVWG!_cIYkj3mq(Ug3y^lFB7_0=rWl-Sl17hDnlNUpeaKuqp6tr>Xne%z2}5zGvgF2mJaG%^p{LYAmzqbp z^we^Z8j0tDb4I32OC90KTq4|(g3^(TN^|qFN91O!k;LKY_@!!O_KgLwr>Un{OYnSt z37+u}Vcd`v=j3Hl0XZtl^Qe)z1-bb47>ajL<~$mTcT|z) zpIFSw=DZcE-$|MCUnt&Lne${Qews4R7om6;RV(vJDBe}oTJqAA#p0n(^E_i>L}OKg zs+IFkD4wWlHae^jAIGZhs_ouL`00usgA4z};-N_Md}fu!Vt3a(kA>nrRa=DlHCFXf zk>=f4b%r{=Gs9|vk7E_iB66Ox3S(6tmAE^SeqUveh@WXK&c}3~k5gZ@hYRTZZc``w zPv`X*)m1fx^~*@XRbK~=f}a!|l79I5<8t6O)mJ5ppX3L97UQ2SLOiR1lbwt(`**Yc z$^Eh&c%*i{$ohTN>OC1aGIum^PY}mse|v_5U`5Xm(&s4t5q`@s2eE1)f8#zR947oN z!RZ-B`p};_Cw%=72lM=lB#y2U{IN8R)3c29DHQy*>m1C#!QV=i3w|I=7Y#=oBd*sG3M| zK8y8xpOm*_fh&xo@bNN3@bK|33MG?U?@4i!dVk69r!(c3!B_cFa6~Qt(5#Z$KZ@{{w=5 zdxyqzSgO=lg3n#8@iBsr$GSR_KXVxGs%m83M%ejt4RC7LMzPaPaN3?c9eDV8VTI_o z6*^dRk?8-8^@XvJw?%*E?;VWhi0ph^SWvwUVR>?i;2GCzeY@x{7X0`sjgJ=m0l}}h zQ{!g8d?L6<`hBqI(}f1rJMIRpZ{}M!6R*_xAkiNo_@?C=e+6-;&vM{)J_`M!XXhf} zwZJ3w%kxq2*Q4N{0Pl|Z{FdDrT(P*LJ_kg9-4Ve&zzB+a6caqJUpNG2>!Fg z&5T1gETqWJd>N-hxfZ2H34XuC&Gf$rc%(S2iGptyJ3S?yX4$QR&yo3LoYeb);J4rD zV5Cg&=@=^H=L*p`&qvn_K3wv|Y}cOzA1eM&7dxHM5VG@7m9{@X@L_^)4V!PL12=sZ zRVJ53!Aqjx>jbC2`eFV24LJF;Hf$dFH*mXEQI2g1TK|qh2P5WrBw6r-Vewod_@iO= zZwDT!U5|?X6_wh4vef$~@a~rD7c&n(W*qDJJsGTN&WEjHXQt#8n!}&7vB5_5(%&et ze#Qf*IE1e^as*$wTI*w2@n?&51Y^j z(}4*tOb@8UNjak6EMfX=48?!99YT`gT+rsoskKlAq!05Vzo4!}?{F;CF=eM{<7fV z>zrobsQRSO(I|M29@?LW!ut_;_n1DaxAePda0&28_HP$Edu2SD>#GL@U%bM>Cd__+ zLhx%P9|lSVuL7rdHb}i@JP(Ne8nI)}hp|1i{%X-T^S?82>i4(8)+gr){-ogMx^X7i ziAhlOcaN-}d7>YFy;Caqtuk+z`|f`Q9w|OAi~iBuwS6-_p9-EO@i+6iYcI0XRoTU# z9C7L_#;qRe<59pl&u`H7%{WgMeCvu(JT;1)T+ye$>qH;3-j#xfw|BST>1A4(Lt^LCEl$txYKXX0ysM~d4v(Lc?r^%rs}{7xo{K5g+tveOed#V1SbnDLn} zc=-7=U+|=5y51R5?_Gk2&tp#sevzE7$BTXfHhL(ZTf*|Wm*5-2^7b6yk)Nc0A&zIdAtvK&amEb<4$q50kuoNh&B2d}Oiq zXS3js3qC;d8N-%8?*fn1FRj2SKJ+KQ=wpuGV`8UR=Dpilir+wE>y7+uzth2p8Ru(& zN3vfQ1z!u?E;g;?L9u^-iGyLg2zLM{KOK8A7(sXQXHOLSA4b7DqC?65ujKrKX7XpI z;IB*EO#CL`RBvrqd{&Bn2N_@Ii=9otBgNrK(f^0&FBJVx1kYRL(0&Ns>8!|h&WnOi z0#5Dvn~X0ruW|+7UZm}B5&Knw-&CV}Ludz7Bsfik&^8A3mRdAb9vZ)8DS^JtpJ&F{yVda9SUR&ofTok>cqVJLk#y z-8`=?6}&<6-<*q`06ra9gCs~Aj&yjH|{bi2RbAU(k za{_R((-3yvoG$qBuz9QyIOUbvlfgBb_HT${e@ztpA+d9Ox3&|<*6_PZ;N;ICdKgXK?u9MHO}y03$IdY1!z1~Pu~eYas^C;WP0j^KW2*K}=0sjOm8iKle& z;*nX(?Y?;WTz6XPy!mdo%FZdyS(00V8@+B%zB>!=Hp?kd5g@layU@KPuW(Ujo;w>a z0xEH5mX;~pD=o^)@#JKWoG^CWcvz00gx3WXxY?!o`8T47g~LmQ zay=oc=6m2qW)&4F_Z9OzX~}MPZXw?$c3+V;kzO0;rne{M&Yf41o}TPZz0^H3HO)D1 zj2r4{W5?h%Ryk$v!o~2SxWwb8H?R?xmkH*E!s2WcBgN4Zii!)fa!N|v^7gC}GC0pY zkIjr8SAaXxZoG*tb4hV#(b8Z&X7Qww(nTenTu-SdN1zGx1}%31xZJt9RK)~OHttX_ zq2qC*-R=@krYARxTbzq`UEKt(u)vKshPktIa09+Hi}|En=+8>KbXrOpij*#Lr@En> zSuz?{;5CA=#IqD{pUZaRy>hwBa@F zbDnd)o8L1=8X>)r9SXqxVvlmq_$^+vmO5S0{c~y(VOPw#WS(b&eqU57f|!Xfr*rfe zyg4dsX-?L4?!24=XMXx6$iyq=%=18S8NXY~O)u^W7ML-{xlA-hbGOkO@jNA|SL)@S=s2Z1^-`Z*A64eQHF;F zj1ZPMBO@UKL_k1vnwfpvI9t4KiSZt*)%Ji8LX_vxb8g+dJU#n3A_6B)EX%rJg$OQ0 zA|N9}oJ>MMMC1q&A`(tSmmu-|fBk=Tb#?Xb>@m`8zv}rvzW-6ZHQ6OtHd~IV(|(?G z+LKJKF@c;0zjgOVB}p2H77W*xPd6kIkdx&l(H;_Gvh{ko#@NH5gJiw)1u>q5GMhjj zR!{n;U}M`PgSHtMP(1CBTAZZCFeL(njo`r%2o>H&+k1xFGxH@xb=d7c9JN6MZn|U8 zdf9eNgnIMgl_{{t9y0;WwGFm^w8}zqQzRFs19NtahFBza(Oq>i+;2WLi>16WGVF8r zkkLGm>Fv@e&IUTg)x*dX%`6{{&A2#caO2J(YGyc@tbrlRDM>sH1v6_owMaLsS$~XS z2jYy*$4Qco`cOR(xMPyDqfP>rAFKf;%Q=97 zajlg5;iCk&L3}lHnl=V{dYod~=yT69HdM;o5~x(kntJC~iPghyjp)2x9H0%Pp67XT z!P5knI-t+6Kj@mo>HrC8m0c`*G#%)zJ`;h=!6fC_p26s;4Nquf#CuL$PS6*);xxF9 zQ2QfT!i9p4&QKbH=vFqqOME4NU?5TJIZUHcnZyc=Oy+0D0C4kY4s2(5Bhhs7c3~TsG}^WesLNg3gQa;v9m?@0QVkN%1YL0*dRWEz@2f;2ML+lVgu*afu42pX`yXQ;99HziLQ3Z$We) zWg9bCm6oW+4M9(4K)0*frdGfLw%7ryNfEeAH`xcx2sZ+(c_7D_L&Pn)>YN4U$dvrL zK*TKYT1}b{^YAf4z^l-KW^56WEYoN>etbDx!>MYvP(WT_Qdy_5=mHzX(q5)bQx%uO zV}8wNxB+($>^_{g!VyR-c*G8GMGs3wBRsZRc&jv`K_`xmZxw+gCjcxj0+nGs8{!qu zI({rJ=cnrPH90uD5N6+lN(*tJ$b6LSP!?`$5v$A`0Tu3G7fXpFCsDjKnBYb=BA17u zC!$0iqReyFxCou$+?q}VB-pklo&8BZog%Ws=Fis81s{4QeY?R*Rvjx(A=U1aj7|X| z%F7b*$vv??W!-GS9v8rJKs1R#U}ISEtEfnZDG-*3Nl}CB1cV)P_H_FLk`0Ys2R}NZ zaCSgjZ!@gj$^G)+sbnt$s}3NP#0Fnpii-gxn(SMP8Vwx)D{f)|j3bs&{D#GDQK(yN zCi%jg7uf`%_{@Wupb;H%qa}dLz8&?Qs+T>m%-@P)urJOB5Cf04oc&i5-wcCfPKnFY zb(U4F0^A9RVD%ni9f92iZAT4iK{n!&VZ7iK)jl}KE9e|iMk65`tyBXc@U+wAc%Pk* zsN+#FbSe`zKBM@rZTe;GnidooB@d8(U<1!##7#~eXw!2+B|_^GM8(;nYz?3go-_!| z2?lb&0CMDhS?3vwEVhJV^R4wzyh$>LjJ^(d<1u41f8mFT5U~za2M%iZ1IK)I#Bof@=q$Z646t(AcQdawExp$oo>)ijx-PwMF_~i1B2$zvt*PUAcm%#0lP62 zF9netZYAUz;gF<98b}4fo`NMv%tCgv;{gq!usev2t^cJ?fdkplLx;rSnV&3)Ftu)@ zY`A8HrL(V&AUtMl`n}*7j%g1+fnzvCHvn4ADgm#_>|=JI62-M)msQ6@ynl9$I6M9DFH~Q*#`=%LlSz#kxJFbwTdNq1WL;E1t(IGnaZV;(y+68 zqB6!8PCZMYAiI9U@JezB(7ggVx*jIc^qfMHA$L%E;x;&cUSTgAO0 z&jE2mKWy7nP5e{`nTrQ(E^Jb|F<2!l)U8ArimonshJHeXfH^EyfjOLKa|+=?E;G^^ z1f(u)icym}>X?)A=1qCiARu=F<5;Dx$3DClWL^v8{WgGHWKJm)UYBK&GQtUqIm8Jh zb3M_iV>Tth0NTZPI3w5wMI3HlINXM%>jASU$2GQCz$p{wHF-V6bQP3#lft>pYFE{j z^Q?_ANc*;|To{9p1tnvG`C#n(HalnVPiiiu$R0MiFLlS6lD^e!nvdXK5-tj4$~EVU z`c7Uw%?22ZB=@&Zc(St%)*RRX#p6T}3zMVcWq~2;zyb(<+j#;)!{(*Rdbssl7;C2Ka1vnPgrJ7^=;Bv2;Ksa_1> z;c(81Z0kO&P%INnpt9?MN`n(>HQrw+aT>qXN{PoB03iFEMiyq+NO}? zf_eQpARPq6Is&iKO@?7Aa|_&yEgE2Mp${7K*5T-ui#Jv41(>YK6Az|Am8_`Llu7yM zVB!FYR$8}!SzzM<6DFrm3846UrLSRHM{N{Qz( zdTUEwY>Dn|9x|44gHfuv^09SdE4)@Ltw-js6sMa-cITy!bhAgQ0SA|z_)1cV<+tLR z>l+QXd*(pR<#}v%PT@o3%7xUll+xn&JxIx$IiqW3ei=$qN8;F5&QR+cOaIpqufevy zfbWj9(%U)Yv!2|*>!+0umGwV(eT(;w(fWg(Lw-Dv8{g%t^3RvbQ$C~j3%`P|*5B+L z;tK!HC^zt$R^=1ce+N(T^GQpsf4y_a<*((2y(;(B(f7-^5dNIt`!#&E{^vV~xWazO za^v}HeA%J{&0Xt%%ieDN1jjGptMzriiR-W00=iF+6z4YdoQ}W1m-fif`noU0LwT?5 z6Dj;^-G)(O|`!6b8-50TjGaOQ2W>V zI{y!){@YSc_rtiB`nt~$)qfq|u>QxmM|2f3yL~f$^-bKwN8b~)S9Yv=PREb%_3P{Y z8qcIYPtL1wPtNuDG^{W0u|C6l`1JYDl|AZTt*6(&#);p*?$`13Q(HpBK#PaNX+4wr zN`Kwga?H zK=aq}>wY31{@&L3t1{MJ*5>~=+$T{b*`$x|i}3j$?R7}+u>ZfK7>SzJ*Zmg$DfPqh z;q|{zm&UL4bsv)#Th{+K>Z)$x)a`fjQtB&VlnmOx&g&)W`2Fj?C@=p+t(E#>ugYs} z=f8O1*LVA;JhwIODPyDot*6J=P}#44@3Z%~qg-~9otp9l(H>fS8pT39xrqo{r z6?ER(#v6D}McR5pj#^*;PeC7Rb9#IO543MBL&qOT|KHYv@-VpMz5^0*$@l(jEBr+a g;CFEO7QRY1#Xr*TSpVPu2Oi+_yYJbf{tf&8AJEwi+5i9m diff --git a/doc/utils/txt2html/txt2html.cpp b/doc/utils/txt2html/txt2html.cpp deleted file mode 100644 index ff71c262c8..0000000000 --- a/doc/utils/txt2html/txt2html.cpp +++ /dev/null @@ -1,940 +0,0 @@ -// txt2html - written by Steve Plimpton, May 2004 -// table formatting by Anna Reese, Jul 2004 -// Sandia National Labs, www.cs.sandia.gov/~sjplimp -// -// txt2html converts a text file with simple formatting & markup into HTML -// formatting & markup specification is given in README -// -// Syntax: txt2html options file read one file, write to stdout -// txt2html optoins file1 file2 ... read files, write files.html -// -// options: -// -b = add a page-break comment to end of each HTML file -// useful when set of HTML files will be converted to PDF -// -x file = skip a file even if it appears in file list -// specify full file name of input file -// input files are first opened as-is -// if that fails a .txt suffix is added -// output files have an .html suffix added or replaced -// (unless written to stdout) - -#include -#include -#include - -#include -#include -#include - -using namespace std; - -#define MAXLINE 1024 - -// function prototypes - -static int next_paragraph(FILE *fp, string ¶graph); -static int index_of_first_char_of_last_word(string ¶graph); -static void process_commands(int flag, string &s, string &pre, string &post); -static void substitute(string &s); -static string td_tag(int currentc); -static long find_n(string &s, int nend, int &n1); -static void file_open(int npair, string &infile, FILE **in, FILE **out); - -// global variables for links, tables, lists, all command - -vector alias1; -vector alias2; -int nlink; - -int tableflag; // makes a table if tb command specified -int rowquit; // number of cols per row if c=N specified (default = 0) -string dwidth; // width for all of the columns -string tabledelim; // speciallized separator -string tablealign; // alignment for the table as an image -string dataalign; // alignment for data in table -string rowvalign; // vertical alignment for table - -int ncnum; // # of columns with specified width -vector cnum; // column IDs -vector cwidth; // column widths - -int ncalign; // # of columns with specified alignment -vector acolnum; // column IDs -vector colalign ; // column alignment - -int ncvalign; // # of columns with specified vertical alignment -vector vacolnum; // column IDs -vector colvalign ; // column vertical alignment - -string listflag; -string allflag; - -// main program - -int main(int narg, char **arg) -{ - int npair; - size_t n; - string *infile; - FILE *in,*out; - int style,ifirst,ilast; - string raw,pre,post,body,commands,final; - - // parse command-line options and args - // setup list of files to process - // npair = # of files to process - // infile = input file names - - if (narg == 1) { - fprintf(stderr,"Syntax: txt2html options file\n"); - fprintf(stderr," txt2html options file1 file2 ...\n"); - exit(1); - } - - int breakflag = 0; - int nskip = 0; - char **skipfiles = NULL; - - int iarg = 1; - while (arg[iarg][0] == '-') { - if (strcmp(arg[iarg],"-b") == 0) breakflag = 1; - else if (strcmp(arg[iarg],"-x") == 0) { - skipfiles = (char **) realloc(skipfiles,(nskip+1)*sizeof(char *)); - n = strlen(arg[iarg+1]) + 1; - skipfiles[nskip] = new char[n]; - strcpy(skipfiles[nskip],arg[iarg+1]); - nskip++; - iarg++; - } else { - fprintf(stderr,"Syntax: txt2html options file\n"); - fprintf(stderr," txt2html options file1 file2 ...\n"); - exit(1); - } - iarg++; - } - - if (narg-iarg == 1) { - npair = 1; - infile = new string[npair]; - infile[0] = arg[narg-1]; - } else { - npair = narg-iarg; - infile = new string[npair]; - for (int i = 0; i < npair; i++) infile[i] = arg[i+iarg]; - } - - // loop over files - - for (int ipair = 0; ipair < npair; ipair++) { - - // skip file if matches -x switch - - int flag = 0; - for (int i = 0; i < nskip; i++) - if (strcmp(infile[ipair].c_str(),skipfiles[i]) == 0) flag = 1; - if (flag) continue; - - // clear global variables before processing file - - alias1.clear(); - alias2.clear(); - nlink = 0; - tableflag = 0; - listflag = ""; - allflag = ""; - - // open files & message to screen - - file_open(0,infile[ipair],&in,&out); - fprintf(stderr,"Converting %s ...\n",infile[ipair].c_str()); - - // scan file for link definitions - // read file one paragraph at a time - // process commands, looking only for link definitions - - while ((style = next_paragraph(in,raw))) { - - if (style == 2) { - int n = index_of_first_char_of_last_word(raw); - commands = raw.substr(n+1); - process_commands(0,commands,pre,post); - } - - raw.erase(); - } - - // close & reopen files - - fclose(in); - file_open(npair,infile[ipair],&in,&out); - - // write leading - - fprintf(out,"\n"); - - // process entire file - // read file one paragraph at a time - // delete newlines when line-continuation char at end-of-line - // process commands for each paragraph - // substitute text for each paragraph - // write HTML to output file - - int rstflag = 0; - - while ((style = next_paragraph(in,raw))) { - - if (rstflag && raw.find("END_RST -->") != string::npos) { - rstflag = 0; - raw.erase(); - continue; - } else if (rstflag == 0 && raw.find("\n"); - fprintf(out,"\n"); - - // close files - - fclose(in); - if (out != stdout) fclose(out); - } - - // clean up memory - - for (int i = 0; i < nskip; i++) delete [] skipfiles[i]; - if (skipfiles) free(skipfiles); - delete [] infile; -} - -// return next paragraph as string -// discard leading blank lines -// paragraph is terminated by: -// EOF or blank line or line ending with command that starts with ":" -// return 0 if EOF and no paragraph -// return 1 if no trailing command -// return 2 if trailing command - -int next_paragraph(FILE *fp, string ¶graph) -{ - char *ptr; - char str[MAXLINE]; - int first = 1; - int len = 0; - - while (1) { - ptr = fgets(str,MAXLINE,fp); - if (ptr == NULL && first) return 0; - if (ptr == NULL) return 1; - len = strlen(str); - if (len == MAXLINE-1) { - fprintf(stderr,"ERROR: File has too-long a string - increase MAXLINE\n"); - exit(1); - } - - // check for valid 7-bit ascii characters - bool nonascii = false; - for (int i=0; i < len; ++i) { - char c = str[i]; - if (c != '\n' && c != '\t' && (c < ' ' || c > '~')) - nonascii = true; - } - if (nonascii) - fprintf(stderr,"WARNING: Non-portable characters in line: %s",ptr); - - if (strspn(str," \t\n") == strlen(str) && first) continue; - if (strspn(str," \t\n") == strlen(str)) return 1; - first = 0; - - paragraph += str; - if (paragraph[index_of_first_char_of_last_word(paragraph)] == ':') - return 2; - } -} - -// return index of first char in last word of paragraph string - -int index_of_first_char_of_last_word(string ¶graph) -{ - size_t n = paragraph.find_last_not_of(" \t\n"); - size_t m = paragraph.find_last_of(" \t\n",n); - if (m == string::npos) return 0; - else return m+1; -} - -// apply commands one after the other to the paragraph - -void process_commands(int flag, string &s, string &pre, string &post) -{ - size_t start,stop,last; - int narg; - string command; - vector arg; - - start = 0; - last = s.find_last_not_of(" \t\n"); - if (last == string::npos) return; - - while (start <= last) { - - // grab a single command with optional arguments - // command = name of command - // narg = # of args - // arg = list of argument strings - - stop = s.find_first_of(",( \t\n",start); - if (s[stop] == '(') { - command = s.substr(start,stop-start); - start = stop+1; - narg = 0; - while (1) { - stop = s.find_first_of(",)",start); - if (stop == string::npos) { - fprintf(stderr,"ERROR: No trailing parenthesis in %s\n",s.c_str()); - exit(1); - } - arg.resize(narg+1); - arg[narg] = s.substr(start,stop-start); - narg++; - start = stop+1; - if (s[stop] == ')') { - start++; - break; - } - } - } else { - command = s.substr(start,stop-start); - start = stop+1; - narg = 0; - } - - // if only in scan mode, just operate on link command - - if (flag == 0) { - if (command == "link" && narg == 2) { - // s.erase(s.length()-1,1); - for (int i = 0; i < nlink; i++) - if (alias1[i] == arg[0]) { - fprintf(stderr,"ERROR: Link %s appears more than once\n", - arg[0].c_str()); - exit(1); - } - alias1.resize(nlink+1); - alias2.resize(nlink+1); - alias1[nlink] = arg[0]; - alias2[nlink] = arg[1]; - nlink++; - } else continue; - } - - // process the command - - if (command == "line") { - pre.append("
"); - } else if (command == "p") { - pre.append("

"); - post.insert(0,"

"); - } else if (command == "pre") { - pre.append("
");
-      post.insert(0,"
"); - } else if (command == "c") { - pre.append("
"); - post.insert(0,"
"); - } else if (command == "h1") { - pre.append("

"); - post.insert(0,"

"); - } else if (command == "h2") { - pre.append("

"); - post.insert(0,"

"); - } else if (command == "h3") { - pre.append("

"); - post.insert(0,"

"); - } else if (command == "h4") { - pre.append("

"); - post.insert(0,"

"); - } else if (command == "h5") { - pre.append("
"); - post.insert(0,"
"); - } else if (command == "h6") { - pre.append("
"); - post.insert(0,"
"); - } else if (command == "b") { - post.insert(0,"
"); - } else if (command == "ulb") { - pre.append("
    "); - } else if (command == "ule") { - post.insert(0,"
"); - } else if (command == "olb") { - pre.append("
    "); - } else if (command == "ole") { - post.insert(0,"
"); - } else if (command == "dlb") { - pre.append("
"); - } else if (command == "dle") { - post.insert(0,"
"); - } else if (command == "l") { - pre.append("
  • "); - } else if (command == "dt") { - pre.append("
    "); - } else if (command == "dd") { - pre.append("
    "); - } else if (command == "ul") { - listflag = command; - pre.append("
      "); - post.insert(0,"
    "); - } else if (command == "ol") { - listflag = command; - pre.append("
      "); - post.insert(0,"
    "); - } else if (command == "dl") { - listflag = command; - pre.append("
    "); - post.insert(0,"
    "); - } else if (command == "link") { - if (narg == 1) { - string aname = "
    "; - pre.append(aname); - } - } else if (command == "image") { - if (narg == 1) { - string img = ""; - pre.append(img); - } else if (narg == 2) { - string img = "" + - "" + ""; - pre.append(img); - } - } else if (command == "tb") { // read the table command and set settings - tableflag = 1; - - string tableborder = "1"; // these are the table defaults - rowquit = 0; - tablealign = "c"; - dataalign = "0"; - rowvalign = "0"; - - ncnum = 0; - ncalign = 0; - ncvalign = 0; - - cnum.clear(); - acolnum.clear(); - vacolnum.clear(); - - cwidth.clear(); - colalign.clear(); - colvalign.clear(); - - tabledelim = ","; - string tw = ""; - dwidth = "0"; - - for (int i = 0; i < narg; i++) { // loop through each tb() arg - int tbstop; - string tbcommand; - tbstop = 0; - tbstop = arg[i].find("="); - tbcommand = arg[i].substr(0,tbstop); - int n = arg[i].length(); - if (tbstop == -1) { - continue; - } else if (tbcommand == "c") { - string collumn= arg[i].substr (tbstop+1,n-(tbstop+1)); - rowquit = atoi(collumn.c_str()); - } else if (tbcommand == "s") { - tabledelim= arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand == "b") { - tableborder= arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand == "w") { - string width = "0"; - if (arg[i].substr (n-1,1) == "%") { - string width = arg[i].substr (tbstop+1,n-(tbstop+1)); - tw = " WIDTH=\"" + width + "\""; - } else - dwidth = arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand == "ea") { - dataalign= arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand == "eva") { - rowvalign= arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand == "a") { - tablealign= arg[i].substr (tbstop+1,n-(tbstop+1)); - } else if (tbcommand.substr(0,2) == "cw") { - string cwnum= tbcommand.substr(2,tbstop-1); - cnum.resize(ncnum+1); - cnum[ncnum] = atoi(cwnum.c_str()); - cwidth.resize(ncnum+1); - cwidth[ncnum]= arg[i].substr(tbstop+1,n-(tbstop+1)); - ncnum++; - } else if (tbcommand.substr(0,2) == "ca") { - string canum= tbcommand.substr(2,tbstop-1); - acolnum.resize(ncalign+1); - acolnum[ncalign] = atoi(canum.c_str()); - colalign.resize(ncalign+1); - colalign[ncalign]= arg[i].substr(tbstop+1,n-(tbstop+1)); - ncalign++; - } else if (tbcommand.substr(0,3) == "cva") { - string cvanum= tbcommand.substr(2,tbstop-1); - vacolnum.resize(ncvalign+1); - vacolnum[ncvalign] = atoi(cvanum.c_str()); - colvalign.resize(ncvalign+1); - colvalign[ncvalign]= arg[i].substr(tbstop+1,n-(tbstop+1)); - ncvalign++; - } else { - fprintf(stderr, - "ERROR: Unrecognized table command %s\n",tbcommand.c_str()); - exit(1); - } - - tbstop = s.find("="); - } - - string align; - if (tablealign=="c") align="center"; - else if (tablealign=="r") align="right "; - else if (tablealign=="l") align="left "; - else align="center"; - string tablea = "
    " ; - pre.append(tablea); - pre.append("\n"; - pre.append(border); - post.insert(0,"
    \n"); - - } else if (command == "all") { - if (narg == 1) allflag = arg[0]; - - } else { - fprintf(stderr,"ERROR: Unrecognized command %s\n",command.c_str()); - exit(1); - } - } -} - -// perform substitutions within text of paragraph - -void substitute(string &s) -{ - size_t n,m,p; - char c; - string text,link,href; - string punctuation = ".,?!;:()"; - - // substitute for bold & italic markers - // if preceded by \ char, then leave markers in text - - n = s.find_first_of("[]{}"); - while (n != string::npos) { - c = s[n]; - if (n > 0 && s[n-1] == '\\') s.erase(n-1,1); - else { - s.erase(n,1); - if (c == '[') s.insert(n,""); - else if (c == ']') s.insert(n,""); - else if (c == '{') s.insert(n,""); - else if (c == '}') s.insert(n,""); - } - n = s.find_first_of("[]{}",n); - } - - // substitute for links - - n = s.find("\"_"); - while (n != string::npos) { - m = s.rfind("\"",n-1); - if (m == string::npos) { - fprintf(stderr,"ERROR: Could not find matching \" for \"_ in %s\n", - s.c_str()); - exit(1); - } - - p = s.find_first_of(" \t\n",n) - 1; - if (p == string::npos) { - fprintf(stderr,"ERROR: Could not find end-of-link in %s\n",s.c_str()); - exit(1); - } - while (s.find_first_of(".,?!;:()",p) == p) p--; - - text = s.substr(m+1,n-m-1); - link = s.substr(n+2,p-n-1); - for (int i = 0; i < nlink; i++) - if (alias1[i] == link) { - link = alias2[i]; - break; - } - - s.erase(m,p-m+1); - href = "" + text + ""; - s.insert(m,href); - n = s.find("\"_"); - } - - // format the paragraph as a table - - if (tableflag) { - tableflag = 0; - - string DT; - - // set up tag - // alignment for data in rows - - string tbalign; - if (dataalign != "0"){ - string align; - if (dataalign=="c") align="\"center\""; - else if (dataalign=="r") align="\"right\""; - else if (dataalign=="l") align="\"left\""; - else { - fprintf(stderr, - "ERROR: Unrecognized table alignment argument %s for ea=X\n", - dataalign.c_str()); - exit(1); - } - tbalign = " ALIGN=" + align; - } else tbalign=""; - - // set up vertical alignment for particular columns - - string va; - if (rowvalign != "0"){ - string valign; - if (rowvalign == "t") valign= "top"; - else if (rowvalign == "m") valign= "middle"; - else if (rowvalign == "ba") valign= "baseline"; - else if (rowvalign == "bo") valign= "bottom"; - else { - fprintf(stderr, - "ERROR: Unrecognized table alignment argument %s for eva=X\n", - rowvalign.c_str()); - exit(1); - } - va = " VALIGN =\"" + valign + "\""; - } else va=""; - - //tr_tag is keyword for data in rows - - string tr_tag= ""; - - //declare integers to help with counting and finding position - - int currentc=0; // current column - int nend = 0; - int n1=0; - long n = find_n(s,nend,n1); - - // if there are no separators, go to the end of the string - - if (n < 0) n = s.length(); - - // while n exists: - - while (n != static_cast(string::npos)) { - - // ignore = 0 when pass by \n because looking for delimiters only - // when ignore==0 do not put in a - int ignore=1; - - // For each loop starts nend at n - nend=n; - - // current column is 0, (very first loop), insert first - if (currentc == 0){ - currentc++; - DT=td_tag(currentc); - s.insert(0,tr_tag); - s.insert(tr_tag.length(),DT); - nend=nend+tr_tag.length()+DT.length(); - n = find_n(s,nend,n1); - if (n==n1) currentc++; - else { - // currentc will remain one if rowquit==0 - if (rowquit>0){ - s.erase(n,1); - n = find_n(s,nend,n1); - currentc++; - } - } - } else { - - // if n is separator - if (n == n1){ - s.erase(n,tabledelim.length()); - if(currentc==(rowquit+1)&& rowquit!=0){ - s.insert(nend,"\n"); - nend=nend+11; - // set current column back to one to start new line - currentc=1; - }else{ - DT= td_tag(currentc); - s.insert (nend,""); - nend=nend+5; - s.insert (nend,DT); - nend=nend+DT.length(); - // add one so current column is updated - currentc++; - n = find_n(s,nend,n1); - } - - } - //if n is newline character - else{ - s.erase(n,1); - // if columns == 0 means ARE searching for newlines - // else erase and ignore insert later and - // search for next separator - - if (rowquit==0){ - s.insert(nend,"\n"); - nend=nend+11; - // set current column back to one to start new line - currentc=1; - }else{ - ignore=0; - n = find_n(s,nend,n1); - } - } - - // if we are at the beginning of the row then insert - - if (currentc==1&&ignore) { - DT = td_tag(currentc); // find DT for currentc=1 - s.insert(nend,tr_tag); - nend=nend+tr_tag.length(); - s.insert(nend,DT); - n = find_n(s,nend,n1); // search for next separator - currentc++; - } - } // end to else statement - } // end to while loop - } // end to if tableflag - - // if listflag is set, put list marker at beginning of every line - - if (listflag != "") { - string marker; - int toggle = 0; - - n = s.find('\n'); - while (n != string::npos) { - m = s.rfind('\n',n-1); - if (listflag == "dl" && toggle == 0) marker = "
    "; - else if (listflag == "dl" && toggle == 1) marker = "
    "; - else marker = "
  • "; - if (m == string::npos) s.insert(0,marker); - else s.insert(m+1,marker); - n = s.find('\n',m+1); - n = s.find('\n',n+1); - if (toggle) toggle = 0; - else toggle = 1; - } - - listflag = ""; - } - - // if allflag is set, add markers to every line - - if (allflag != "") { - string marker1,marker2; - if (allflag == "p") { - marker1 = "

    "; - marker2 = "

    "; - } else if (allflag == "c") { - marker1 = "
    "; - marker2 = "
    "; - } else if (allflag == "b") { - marker1 = ""; - marker2 = "
    "; - } else if (allflag == "l") { - marker1 = "
  • "; - marker2 = ""; - } else marker1 = marker2 = ""; - - n = s.find('\n'); - while (n != string::npos) { - m = s.rfind('\n',n-1); - if (m == string::npos) s.insert(0,marker1); - else s.insert(m+1,marker1); - n = s.find('\n',m+1); - s.insert(n,marker2); - n = s.find('\n',n); - n = s.find('\n',n+1); - } - - allflag = ""; - } -} - -// open input file as-is or as file.txt -// if npair = 0, don't open output file (is just initial pass thru input) -// if npair = 1, open output file as stdout -// if npair > 1, open output file with .html suffix -// either replace .txt in input file, or append .html - -void file_open(int npair, string &infile, FILE **in, FILE **out) -{ - *in = fopen(infile.c_str(),"r"); - if (*in == NULL) { - string root = infile; - infile = infile + ".txt"; - *in = fopen(infile.c_str(),"r"); - if (*in == NULL) { - fprintf(stderr,"ERROR: Could not open %s or %s\n", - root.c_str(),infile.c_str()); - exit(1); - } - } - - if (npair == 0) return; - else if (npair == 1) *out = stdout; - else { - string outfile; - size_t pos = infile.rfind(".txt"); - if (pos == infile.length()-4) outfile = infile.substr(0,pos) + ".html"; - else outfile = infile + ".html"; - *out = fopen(outfile.c_str(),"w"); - if (*out == NULL) { - fprintf(stderr,"ERROR: Could not open %s\n",outfile.c_str()); - exit(1); - } - } -} - -// for tables: -// build string (DT) based on current column - -string td_tag(int currentc) { - - // eacolumn gives the alignment printout of a specific column - string eacolumn; - // va gives vertical alignment to a specific column - string va; - // DT is the complete tag, with width and align - string DT; - // dw is the width for tables. It is also the
    tag beginning - string dw; - - // set up alignment for particular columns - - for (int counter=0; counter < ncalign; counter++){ - if (ncalign != 0 && acolnum[counter] == currentc){ - string align; - if (colalign[counter] == "l") align= "left"; - else if (colalign[counter] == "r") align= "right"; - else if (colalign[counter] == "c") align= "center"; - else { - fprintf(stderr, - "ERROR: Unrecognized table alignment argument %s for caM=X\n", - colalign[counter].c_str()); - exit(1); - } - eacolumn= " ALIGN =\"" + align +"\""; - }else eacolumn= ""; - } - - // set up vertical alignment for particular columns - - for (int counter=0; counter < ncvalign; counter++){ - if (ncvalign != 0 && vacolnum[counter] == currentc){ - string valign; - if (colvalign[counter] == "t") valign= "top"; - else if (colvalign[counter] == "m") valign= "middle"; - else if (colvalign[counter] == "ba") valign= "baseline"; - else if (colvalign[counter] == "bo") valign= "bottom"; - else { - fprintf(stderr, - "ERROR: Unrecognized table alignment argument %s for cvaM=X\n", - colvalign[counter].c_str()); - exit(1); - } - va = " VALIGN =\"" + valign + "\""; - } else va = " "; - } - - // put in special width if specified - // new code - // if dwidth has not been set, dw is blank - // if dwidth has been set, dw has that... unless - - if (dwidth=="0") dw = " "; - else dw =" WIDTH=\""+ dwidth + "\""; - - for (int counter = 0; counter < ncnum; counter++){ - // if it is the right column, dw = cwidth property - if (cnum[counter] == currentc) dw= " WIDTH=\"" + cwidth[counter] + "\""; - } - - // DT is set for all of this particular separator : reset next separator - - DT = ""; - - return DT; -} - -// for tables: -// find the next separator starting at nend(the end of the last .insert) -// if there is either a delim or newline -// decide which is first -// set n = to that position -// nsep is position of the next separator. changes in here. - -long find_n(string &s, int nend, int &nsep) - // nsep is position of the next separator. changes in here. -{ - long n; - nsep = s.find(tabledelim,nend); - long n2 = s.find('\n',nend); - long m = s.length() - 1; - if (nsep >= 0 && n2 >= 0) { - if (nsep <= n2) n = nsep; - else n = n2; - } else { - if (nsep >= 0) n = nsep; - else{ - if (n2 < m) n = n2; - else n = string::npos; - } - } - - return n; -} From 9e7ca428aade7fdfad8254c63833a390e2f983a7 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Nov 2019 10:57:18 -0500 Subject: [PATCH 333/557] whitespace cleanup: remove (evil) tabs --- src/BODY/body_rounded_polygon.cpp | 8 +- src/BODY/body_rounded_polyhedron.cpp | 4 +- src/CLASS2/pair_lj_class2.cpp | 20 +- src/CLASS2/pair_lj_class2_coul_long.cpp | 36 +-- src/KOKKOS/atom_vec_sphere_kokkos.cpp | 144 ++++++------ src/KOKKOS/fix_enforce2d_kokkos.cpp | 4 +- src/KOKKOS/fix_neigh_history_kokkos.cpp | 44 ++-- src/KOKKOS/npair_kokkos.cpp | 208 +++++++++--------- src/KOKKOS/pair_gran_hooke_history_kokkos.cpp | 148 ++++++------- src/KOKKOS/verlet_kokkos.cpp | 4 +- src/KSPACE/ewald_disp.cpp | 2 +- src/KSPACE/pppm_disp.cpp | 4 +- src/SPIN/atom_vec_spin.h | 12 +- src/SPIN/fix_langevin_spin.h | 16 +- src/SPIN/fix_neb_spin.h | 24 +- src/SPIN/fix_nve_spin.cpp | 8 +- src/SPIN/fix_nve_spin.h | 36 +-- src/SPIN/fix_precession_spin.cpp | 8 +- src/SPIN/fix_precession_spin.h | 14 +- src/SPIN/min_spin.cpp | 6 +- src/SPIN/min_spin_cg.cpp | 12 +- src/SPIN/min_spin_cg.h | 30 +-- src/SPIN/min_spin_lbfgs.cpp | 8 +- src/SPIN/min_spin_lbfgs.h | 32 +-- src/SPIN/neb_spin.cpp | 108 ++++----- src/SPIN/pair_spin.h | 4 +- src/SPIN/pair_spin_dipole_cut.cpp | 42 ++-- src/SPIN/pair_spin_dipole_cut.h | 14 +- src/SPIN/pair_spin_dipole_long.h | 14 +- src/SPIN/pair_spin_dmi.h | 10 +- src/SPIN/pair_spin_exchange.h | 8 +- src/SPIN/pair_spin_magelec.h | 8 +- src/SPIN/pair_spin_neel.h | 12 +- src/USER-MISC/compute_hma.cpp | 2 +- src/USER-MISC/fix_bond_react.cpp | 12 +- src/USER-MISC/pair_ilp_graphene_hbn.cpp | 14 +- src/USER-MISC/pair_kolmogorov_crespi_full.cpp | 28 +-- src/USER-MISC/pair_lj_expand_coul_long.cpp | 4 +- src/USER-MISC/pair_local_density.cpp | 88 ++++---- src/USER-MISC/pair_local_density.h | 12 +- src/USER-OMP/reaxc_init_md_omp.cpp | 4 +- src/USER-REAXC/reaxc_ffield.cpp | 2 +- src/force.cpp | 6 +- src/min.h | 8 +- src/min_cg.cpp | 8 +- src/min_fire.cpp | 6 +- src/min_sd.cpp | 6 +- 47 files changed, 626 insertions(+), 626 deletions(-) diff --git a/src/BODY/body_rounded_polygon.cpp b/src/BODY/body_rounded_polygon.cpp index d60372781a..d855c5aea7 100644 --- a/src/BODY/body_rounded_polygon.cpp +++ b/src/BODY/body_rounded_polygon.cpp @@ -116,7 +116,7 @@ double BodyRoundedPolygon::enclosing_radius(struct AtomVecBody::Bonus *bonus) { int nvertices = bonus->ivalue[0]; if (nvertices == 1 || nvertices == 2) - return *(bonus->dvalue+3*nsub(bonus)+2); + return *(bonus->dvalue+3*nsub(bonus)+2); return *(bonus->dvalue + 3*nsub(bonus) + 2*nsub(bonus)); } @@ -126,7 +126,7 @@ double BodyRoundedPolygon::rounded_radius(struct AtomVecBody::Bonus *bonus) { int nvertices = bonus->ivalue[0]; if (nvertices == 1 || nvertices == 2) - return *(bonus->dvalue+3*nsub(bonus)+2+1); + return *(bonus->dvalue+3*nsub(bonus)+2+1); return *(bonus->dvalue + 3*nsub(bonus) + 2*nsub(bonus)+1); } @@ -156,7 +156,7 @@ int BodyRoundedPolygon::unpack_border_body(AtomVecBody::Bonus *bonus, ------------------------------------------------------------------------- */ void BodyRoundedPolygon::data_body(int ibonus, int ninteger, int ndouble, - int *ifile, double *dfile) + int *ifile, double *dfile) { AtomVecBody::Bonus *bonus = &avec->bonus[ibonus]; @@ -327,7 +327,7 @@ void BodyRoundedPolygon::data_body(int ibonus, int ninteger, int ndouble, ------------------------------------------------------------------------- */ double BodyRoundedPolygon::radius_body(int /*ninteger*/, int ndouble, - int *ifile, double *dfile) + int *ifile, double *dfile) { int nsub = ifile[0]; if (nsub < 1) diff --git a/src/BODY/body_rounded_polyhedron.cpp b/src/BODY/body_rounded_polyhedron.cpp index 49ec6f1d78..a82404ab15 100644 --- a/src/BODY/body_rounded_polyhedron.cpp +++ b/src/BODY/body_rounded_polyhedron.cpp @@ -134,7 +134,7 @@ double BodyRoundedPolyhedron::enclosing_radius(struct AtomVecBody::Bonus *bonus) { int nvertices = bonus->ivalue[0]; if (nvertices == 1 || nvertices == 2) - return *(bonus->dvalue+3*nsub(bonus)+2); + return *(bonus->dvalue+3*nsub(bonus)+2); return *(bonus->dvalue+3*nsub(bonus) + 2*nedges(bonus) + MAX_FACE_SIZE*nfaces(bonus)); } @@ -385,7 +385,7 @@ void BodyRoundedPolyhedron::data_body(int ibonus, int ninteger, int ndouble, ------------------------------------------------------------------------- */ double BodyRoundedPolyhedron::radius_body(int /*ninteger*/, int ndouble, - int *ifile, double *dfile) + int *ifile, double *dfile) { int nsub = ifile[0]; int ned = ifile[1]; diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp index 641ca67226..c930173864 100644 --- a/src/CLASS2/pair_lj_class2.cpp +++ b/src/CLASS2/pair_lj_class2.cpp @@ -188,8 +188,8 @@ void PairLJClass2::compute_inner() if (rsq < cut_out_off_sq) { r2inv = 1.0/rsq; - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; jtype = type[j]; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); @@ -268,8 +268,8 @@ void PairLJClass2::compute_middle() if (rsq < cut_out_off_sq && rsq > cut_in_off_sq) { r2inv = 1.0/rsq; - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; jtype = type[j]; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); @@ -352,8 +352,8 @@ void PairLJClass2::compute_outer(int eflag, int vflag) if (rsq < cutsq[itype][jtype]) { if (rsq > cut_in_off_sq) { r2inv = 1.0/rsq; - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); fpair = factor_lj*forcelj*r2inv; @@ -374,8 +374,8 @@ void PairLJClass2::compute_outer(int eflag, int vflag) if (eflag) { r2inv = 1.0/rsq; - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; evdwl = r6inv*(lj3[itype][jtype]*r3inv-lj4[itype][jtype]) - offset[itype][jtype]; @@ -385,8 +385,8 @@ void PairLJClass2::compute_outer(int eflag, int vflag) if (vflag) { if (rsq <= cut_in_off_sq) { r2inv = 1.0/rsq; - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); fpair = factor_lj*forcelj*r2inv; diff --git a/src/CLASS2/pair_lj_class2_coul_long.cpp b/src/CLASS2/pair_lj_class2_coul_long.cpp index 5487878f27..c2b127fa58 100644 --- a/src/CLASS2/pair_lj_class2_coul_long.cpp +++ b/src/CLASS2/pair_lj_class2_coul_long.cpp @@ -262,8 +262,8 @@ void PairLJClass2CoulLong::compute_inner() jtype = type[j]; if (rsq < cut_ljsq[itype][jtype]) { - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); } else forcelj = 0.0; @@ -354,8 +354,8 @@ void PairLJClass2CoulLong::compute_middle() jtype = type[j]; if (rsq < cut_ljsq[itype][jtype]) { - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); } else forcelj = 0.0; @@ -487,9 +487,9 @@ void PairLJClass2CoulLong::compute_outer(int eflag, int vflag) } else forcecoul = 0.0; if (rsq < cut_ljsq[itype][jtype] && rsq > cut_in_off_sq) { - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; - r6inv = r3inv*r3inv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; + r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); if (rsq < cut_in_on_sq) { rsw = (sqrt(rsq) - cut_in_off)/cut_in_diff; @@ -525,9 +525,9 @@ void PairLJClass2CoulLong::compute_outer(int eflag, int vflag) } else ecoul = 0.0; if (rsq < cut_ljsq[itype][jtype]) { - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; - r6inv = r3inv*r3inv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; + r6inv = r3inv*r3inv; evdwl = r6inv*(lj3[itype][jtype]*r3inv-lj4[itype][jtype]) - offset[itype][jtype]; evdwl *= factor_lj; @@ -552,13 +552,13 @@ void PairLJClass2CoulLong::compute_outer(int eflag, int vflag) if (rsq <= cut_in_off_sq) { rinv = sqrt(r2inv); - r3inv = r2inv*rinv; - r6inv = r3inv*r3inv; + r3inv = r2inv*rinv; + r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); } else if (rsq <= cut_in_on_sq) { - rinv = sqrt(r2inv); - r3inv = r2inv*rinv; - r6inv = r3inv*r3inv; + rinv = sqrt(r2inv); + r3inv = r2inv*rinv; + r6inv = r3inv*r3inv; forcelj = r6inv * (lj1[itype][jtype]*r3inv - lj2[itype][jtype]); } fpair = (forcecoul + factor_lj*forcelj) * r2inv; @@ -672,14 +672,14 @@ void PairLJClass2CoulLong::init_style() if (update->whichflag == 1 && strstr(update->integrate_style,"respa")) { if (((Respa *) update->integrate)->level_inner >= 0) respa = 1; - if (((Respa *) update->integrate)->level_middle >= 0) respa = 2; + if (((Respa *) update->integrate)->level_middle >= 0) respa = 2; } irequest = neighbor->request(this,instance_me); if (respa >= 1) { neighbor->requests[irequest]->respaouter = 1; - neighbor->requests[irequest]->respainner = 1; + neighbor->requests[irequest]->respainner = 1; } if (respa == 2) neighbor->requests[irequest]->respamiddle = 1; @@ -690,7 +690,7 @@ void PairLJClass2CoulLong::init_style() if (strstr(update->integrate_style,"respa") && ((Respa *) update->integrate)->level_inner >= 0) cut_respa = ((Respa *) update->integrate)->cutoff; - else cut_respa = NULL; + else cut_respa = NULL; // insure use of KSpace long-range solver, set g_ewald diff --git a/src/KOKKOS/atom_vec_sphere_kokkos.cpp b/src/KOKKOS/atom_vec_sphere_kokkos.cpp index 7e217df2a6..67aaa32c21 100644 --- a/src/KOKKOS/atom_vec_sphere_kokkos.cpp +++ b/src/KOKKOS/atom_vec_sphere_kokkos.cpp @@ -247,13 +247,13 @@ struct AtomVecSphereKokkos_PackComm { _buf(i,2) = _x(j,2); } else { if (TRICLINIC == 0) { - _buf(i,0) = _x(j,0) + _pbc[0]*_xprd; - _buf(i,1) = _x(j,1) + _pbc[1]*_yprd; - _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; + _buf(i,0) = _x(j,0) + _pbc[0]*_xprd; + _buf(i,1) = _x(j,1) + _pbc[1]*_yprd; + _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; } else { - _buf(i,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; - _buf(i,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; - _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; + _buf(i,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; + _buf(i,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; + _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; } } _buf(i,3) = _radius(j); @@ -419,13 +419,13 @@ struct AtomVecSphereKokkos_PackCommVel { _buf(i,2) = _x(j,2); } else { if (TRICLINIC == 0) { - _buf(i,0) = _x(j,0) + _pbc[0]*_xprd; - _buf(i,1) = _x(j,1) + _pbc[1]*_yprd; - _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; + _buf(i,0) = _x(j,0) + _pbc[0]*_xprd; + _buf(i,1) = _x(j,1) + _pbc[1]*_yprd; + _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; } else { - _buf(i,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; - _buf(i,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; - _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; + _buf(i,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; + _buf(i,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; + _buf(i,2) = _x(j,2) + _pbc[2]*_zprd; } } if (DEFORM_VREMAP == 0) { @@ -772,13 +772,13 @@ struct AtomVecSphereKokkos_PackCommSelf { _xw(i+_nfirst,2) = _x(j,2); } else { if (TRICLINIC == 0) { - _xw(i+_nfirst,0) = _x(j,0) + _pbc[0]*_xprd; - _xw(i+_nfirst,1) = _x(j,1) + _pbc[1]*_yprd; - _xw(i+_nfirst,2) = _x(j,2) + _pbc[2]*_zprd; + _xw(i+_nfirst,0) = _x(j,0) + _pbc[0]*_xprd; + _xw(i+_nfirst,1) = _x(j,1) + _pbc[1]*_yprd; + _xw(i+_nfirst,2) = _x(j,2) + _pbc[2]*_zprd; } else { - _xw(i+_nfirst,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; - _xw(i+_nfirst,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; - _xw(i+_nfirst,2) = _x(j,2) + _pbc[2]*_zprd; + _xw(i+_nfirst,0) = _x(j,0) + _pbc[0]*_xprd + _pbc[5]*_xy + _pbc[4]*_xz; + _xw(i+_nfirst,1) = _x(j,1) + _pbc[1]*_yprd + _pbc[3]*_yz; + _xw(i+_nfirst,2) = _x(j,2) + _pbc[2]*_zprd; } } _radius(i+_nfirst) = _radius(j); @@ -799,39 +799,39 @@ int AtomVecSphereKokkos::pack_comm_self( atomKK->modified(Host,X_MASK|RADIUS_MASK|RMASS_MASK); if(pbc_flag) { if(domain->triclinic) { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } else { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } } else { if(domain->triclinic) { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } else { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } } } else { @@ -839,39 +839,39 @@ int AtomVecSphereKokkos::pack_comm_self( atomKK->modified(Device,X_MASK|RADIUS_MASK|RMASS_MASK); if(pbc_flag) { if(domain->triclinic) { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } else { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } } else { if(domain->triclinic) { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } else { - struct AtomVecSphereKokkos_PackCommSelf f( + struct AtomVecSphereKokkos_PackCommSelf f( atomKK->k_x, - atomKK->k_radius,atomKK->k_rmass, - nfirst,list,iswap, - domain->xprd,domain->yprd,domain->zprd, - domain->xy,domain->xz,domain->yz,pbc); - Kokkos::parallel_for(n,f); + atomKK->k_radius,atomKK->k_rmass, + nfirst,list,iswap, + domain->xprd,domain->yprd,domain->zprd, + domain->xy,domain->xz,domain->yz,pbc); + Kokkos::parallel_for(n,f); } } } @@ -1037,7 +1037,7 @@ void AtomVecSphereKokkos::unpack_comm_vel_kokkos( /* ---------------------------------------------------------------------- */ int AtomVecSphereKokkos::pack_comm(int n, int *list, double *buf, - int pbc_flag, int *pbc) + int pbc_flag, int *pbc) { int i,j,m; double dx,dy,dz; @@ -1109,7 +1109,7 @@ int AtomVecSphereKokkos::pack_comm(int n, int *list, double *buf, /* ---------------------------------------------------------------------- */ int AtomVecSphereKokkos::pack_comm_vel(int n, int *list, double *buf, - int pbc_flag, int *pbc) + int pbc_flag, int *pbc) { int i,j,m; double dx,dy,dz,dvx,dvy,dvz; @@ -1926,7 +1926,7 @@ struct AtomVecSphereKokkos_UnpackBorder { /* ---------------------------------------------------------------------- */ void AtomVecSphereKokkos::unpack_border_kokkos(const int &n, const int &first, - const DAT::tdual_xfloat_2d &buf,ExecutionSpace space) { + const DAT::tdual_xfloat_2d &buf,ExecutionSpace space) { while (first+n >= nmax) grow(0); if(space==Host) { struct AtomVecSphereKokkos_UnpackBorder f(buf.view(), @@ -1943,7 +1943,7 @@ void AtomVecSphereKokkos::unpack_border_kokkos(const int &n, const int &first, } atomKK->modified(space,X_MASK|TAG_MASK|TYPE_MASK|MASK_MASK| - RADIUS_MASK|RMASS_MASK); + RADIUS_MASK|RMASS_MASK); } /* ---------------------------------------------------------------------- */ @@ -2053,7 +2053,7 @@ void AtomVecSphereKokkos::unpack_border_vel_kokkos( } atomKK->modified(space,X_MASK|TAG_MASK|TYPE_MASK|MASK_MASK| - RADIUS_MASK|RMASS_MASK|V_MASK|OMEGA_MASK); + RADIUS_MASK|RMASS_MASK|V_MASK|OMEGA_MASK); } /* ---------------------------------------------------------------------- */ @@ -2496,7 +2496,7 @@ int AtomVecSphereKokkos::unpack_restart(double *buf) atomKK->modified(Host,X_MASK | TAG_MASK | TYPE_MASK | MASK_MASK | IMAGE_MASK | V_MASK | - RADIUS_MASK | RMASS_MASK | OMEGA_MASK); + RADIUS_MASK | RMASS_MASK | OMEGA_MASK); atom->nlocal++; return m; diff --git a/src/KOKKOS/fix_enforce2d_kokkos.cpp b/src/KOKKOS/fix_enforce2d_kokkos.cpp index bf2a882539..205451d96f 100644 --- a/src/KOKKOS/fix_enforce2d_kokkos.cpp +++ b/src/KOKKOS/fix_enforce2d_kokkos.cpp @@ -34,10 +34,10 @@ FixEnforce2DKokkos::FixEnforce2DKokkos(LAMMPS *lmp, int narg, char * execution_space = ExecutionSpaceFromDevice::space; datamask_read = V_MASK | F_MASK | OMEGA_MASK | MASK_MASK - | TORQUE_MASK | ANGMOM_MASK; + | TORQUE_MASK | ANGMOM_MASK; datamask_modify = V_MASK | F_MASK | OMEGA_MASK - | TORQUE_MASK | ANGMOM_MASK; + | TORQUE_MASK | ANGMOM_MASK; } diff --git a/src/KOKKOS/fix_neigh_history_kokkos.cpp b/src/KOKKOS/fix_neigh_history_kokkos.cpp index 8cfe7111dd..7906d37cc3 100644 --- a/src/KOKKOS/fix_neigh_history_kokkos.cpp +++ b/src/KOKKOS/fix_neigh_history_kokkos.cpp @@ -122,21 +122,21 @@ void FixNeighHistoryKokkos::pre_exchange_item(const int &ii) const j &= NEIGHMASK; int m = Kokkos::atomic_fetch_add(&d_npartner[i],1); if (m < maxpartner) { - d_partner(i,m) = tag[j]; - for (int k = 0; k < dnum; k++) - d_valuepartner(i,dnum*m+k) = d_firstvalue(i,dnum*jj+k); + d_partner(i,m) = tag[j]; + for (int k = 0; k < dnum; k++) + d_valuepartner(i,dnum*m+k) = d_firstvalue(i,dnum*jj+k); } else { - d_resize() = 1; + d_resize() = 1; } if (j < nlocal_neigh) { - m = Kokkos::atomic_fetch_add(&d_npartner[j],1); - if (m < maxpartner) { - d_partner(j,m) = tag[i]; - for (int k = 0; k < dnum; k++) - d_valuepartner(j,dnum*m+k) = d_firstvalue(i,dnum*jj+k); - } else { - d_resize() = 1; - } + m = Kokkos::atomic_fetch_add(&d_npartner[j],1); + if (m < maxpartner) { + d_partner(j,m) = tag[i]; + for (int k = 0; k < dnum; k++) + d_valuepartner(j,dnum*m+k) = d_firstvalue(i,dnum*jj+k); + } else { + d_resize() = 1; + } } } } @@ -205,22 +205,22 @@ void FixNeighHistoryKokkos::post_neighbor_item(const int &ii) const if (rflag) { int jtag = tag(j); for (m = 0; m < np; m++) - if (d_partner(i, m) == jtag) break; + if (d_partner(i, m) == jtag) break; if (m < np) { - d_firstflag(i,jj) = 1; - for (int k = 0; k < dnum; k++) { - d_firstvalue(i, dnum*jj+k) = d_valuepartner(i, dnum*m+k); - } + d_firstflag(i,jj) = 1; + for (int k = 0; k < dnum; k++) { + d_firstvalue(i, dnum*jj+k) = d_valuepartner(i, dnum*m+k); + } } else { - d_firstflag(i,jj) = 0; - for (int k = 0; k < dnum; k++) { - d_firstvalue(i, dnum*jj+k) = 0; - } + d_firstflag(i,jj) = 0; + for (int k = 0; k < dnum; k++) { + d_firstvalue(i, dnum*jj+k) = 0; + } } } else { d_firstflag(i,jj) = 0; for (int k = 0; k < dnum; k++) { - d_firstvalue(i, dnum*jj+k) = 0; + d_firstvalue(i, dnum*jj+k) = 0; } } } diff --git a/src/KOKKOS/npair_kokkos.cpp b/src/KOKKOS/npair_kokkos.cpp index 4daf4b84c5..5470001967 100644 --- a/src/KOKKOS/npair_kokkos.cpp +++ b/src/KOKKOS/npair_kokkos.cpp @@ -224,49 +224,49 @@ void NPairKokkos::build(NeighList *list_) Kokkos::parallel_for(nall, f); } else { if (newton_pair) { - if (SIZE) { - NPairKokkosBuildFunctorSize f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); + if (SIZE) { + NPairKokkosBuildFunctorSize f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); #ifdef KOKKOS_ENABLE_CUDA - if (ExecutionSpaceFromDevice::space == Device) - Kokkos::parallel_for(config, f); - else - Kokkos::parallel_for(nall, f); + if (ExecutionSpaceFromDevice::space == Device) + Kokkos::parallel_for(config, f); + else + Kokkos::parallel_for(nall, f); #else - Kokkos::parallel_for(nall, f); + Kokkos::parallel_for(nall, f); #endif - } else { - NPairKokkosBuildFunctor f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); + } else { + NPairKokkosBuildFunctor f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); #ifdef KOKKOS_ENABLE_CUDA - if (ExecutionSpaceFromDevice::space == Device) - Kokkos::parallel_for(config, f); - else - Kokkos::parallel_for(nall, f); + if (ExecutionSpaceFromDevice::space == Device) + Kokkos::parallel_for(config, f); + else + Kokkos::parallel_for(nall, f); #else - Kokkos::parallel_for(nall, f); + Kokkos::parallel_for(nall, f); #endif - } + } } else { - if (SIZE) { - NPairKokkosBuildFunctorSize f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); + if (SIZE) { + NPairKokkosBuildFunctorSize f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); #ifdef KOKKOS_ENABLE_CUDA - if (ExecutionSpaceFromDevice::space == Device) - Kokkos::parallel_for(config, f); - else - Kokkos::parallel_for(nall, f); + if (ExecutionSpaceFromDevice::space == Device) + Kokkos::parallel_for(config, f); + else + Kokkos::parallel_for(nall, f); #else - Kokkos::parallel_for(nall, f); + Kokkos::parallel_for(nall, f); #endif - } else { - NPairKokkosBuildFunctor f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); + } else { + NPairKokkosBuildFunctor f(data,atoms_per_bin * 5 * sizeof(X_FLOAT) * factor); #ifdef KOKKOS_ENABLE_CUDA - if (ExecutionSpaceFromDevice::space == Device) - Kokkos::parallel_for(config, f); - else - Kokkos::parallel_for(nall, f); + if (ExecutionSpaceFromDevice::space == Device) + Kokkos::parallel_for(config, f); + else + Kokkos::parallel_for(nall, f); #else - Kokkos::parallel_for(nall, f); + Kokkos::parallel_for(nall, f); #endif - } + } } } Kokkos::deep_copy(h_scalars, d_scalars); @@ -871,8 +871,8 @@ void NeighborKokkosExecute:: if(rsq <= cutsq) { if(n:: if(HalfNeigh && !Newton && (j < i)) continue; if(!HalfNeigh && j==i) continue; if(Tri) { - if (x(j,2) < ztmp) continue; - if (x(j,2) == ztmp) { - if (x(j,1) < ytmp) continue; - if (x(j,1) == ytmp) { - if (x(j,0) < xtmp) continue; - if (x(j,0) == xtmp && j <= i) continue; - } - } + if (x(j,2) < ztmp) continue; + if (x(j,2) == ztmp) { + if (x(j,1) < ytmp) continue; + if (x(j,1) == ytmp) { + if (x(j,0) < xtmp) continue; + if (x(j,0) == xtmp && j <= i) continue; + } + } } if(exclude && exclusion(i,j,itype,jtype)) continue; @@ -911,11 +911,11 @@ void NeighborKokkosExecute:: const X_FLOAT cutsq = (radsum + skin) * (radsum + skin); if(rsq <= cutsq) { - if(n::build_ItemSizeCuda(typename Kokkos::Team if(i >= 0 && i < nlocal) { #pragma unroll 4 for(int m = 0; m < bincount_current; m++) { - int j = other_id[m]; - const int jtype = other_x[m + 3 * atoms_per_bin]; + int j = other_id[m]; + const int jtype = other_x[m + 3 * atoms_per_bin]; - //for same bin as atom i skip j if i==j and skip atoms "below and to the left" if using halfneighborlists - if((j == i) || - (HalfNeigh && !Newton && (j < i)) || - (HalfNeigh && Newton && + //for same bin as atom i skip j if i==j and skip atoms "below and to the left" if using halfneighborlists + if((j == i) || + (HalfNeigh && !Newton && (j < i)) || + (HalfNeigh && Newton && ((j < i) || - ((j >= nlocal) && ((x(j, 2) < ztmp) || (x(j, 2) == ztmp && x(j, 1) < ytmp) || - (x(j, 2) == ztmp && x(j, 1) == ytmp && x(j, 0) < xtmp))))) - ) continue; + ((j >= nlocal) && ((x(j, 2) < ztmp) || (x(j, 2) == ztmp && x(j, 1) < ytmp) || + (x(j, 2) == ztmp && x(j, 1) == ytmp && x(j, 0) < xtmp))))) + ) continue; if(Tri) { if (x(j,2) < ztmp) continue; if (x(j,2) == ztmp) { @@ -1011,21 +1011,21 @@ void NeighborKokkosExecute::build_ItemSizeCuda(typename Kokkos::Team } } } - if(exclude && exclusion(i,j,itype,jtype)) continue; - const X_FLOAT delx = xtmp - other_x[m]; - const X_FLOAT dely = ytmp - other_x[m + atoms_per_bin]; - const X_FLOAT delz = ztmp - other_x[m + 2 * atoms_per_bin]; - const X_FLOAT rsq = delx * delx + dely * dely + delz * delz; - const X_FLOAT radsum = radi + other_x[m + 4 * atoms_per_bin]; - const X_FLOAT cutsq = (radsum + skin) * (radsum + skin); + if(exclude && exclusion(i,j,itype,jtype)) continue; + const X_FLOAT delx = xtmp - other_x[m]; + const X_FLOAT dely = ytmp - other_x[m + atoms_per_bin]; + const X_FLOAT delz = ztmp - other_x[m + 2 * atoms_per_bin]; + const X_FLOAT rsq = delx * delx + dely * dely + delz * delz; + const X_FLOAT radsum = radi + other_x[m + 4 * atoms_per_bin]; + const X_FLOAT cutsq = (radsum + skin) * (radsum + skin); - if(rsq <= cutsq) { - if(n::build_ItemSizeCuda(typename Kokkos::Team int j = MY_II < bincount_current ? c_bins(jbin, MY_II) : -1; if(j >= 0) { - other_x[MY_II] = x(j, 0); - other_x[MY_II + atoms_per_bin] = x(j, 1); - other_x[MY_II + 2 * atoms_per_bin] = x(j, 2); - other_x[MY_II + 3 * atoms_per_bin] = type(j); - other_x[MY_II + 4 * atoms_per_bin] = radius(j); + other_x[MY_II] = x(j, 0); + other_x[MY_II + atoms_per_bin] = x(j, 1); + other_x[MY_II + 2 * atoms_per_bin] = x(j, 2); + other_x[MY_II + 3 * atoms_per_bin] = type(j); + other_x[MY_II + 4 * atoms_per_bin] = radius(j); } other_id[MY_II] = j; @@ -1054,40 +1054,40 @@ void NeighborKokkosExecute::build_ItemSizeCuda(typename Kokkos::Team if(i >= 0 && i < nlocal) { #pragma unroll 8 - for(int m = 0; m < bincount_current; m++) { - const int j = other_id[m]; - const int jtype = other_x[m + 3 * atoms_per_bin]; + for(int m = 0; m < bincount_current; m++) { + const int j = other_id[m]; + const int jtype = other_x[m + 3 * atoms_per_bin]; - if(HalfNeigh && (j < i)) continue; - if(HalfNeigh && !Newton && (j < i)) continue; - if(!HalfNeigh && j==i) continue; - if(Tri) { - if (x(j,2) < ztmp) continue; - if (x(j,2) == ztmp) { - if (x(j,1) < ytmp) continue; - if (x(j,1) == ytmp) { - if (x(j,0) < xtmp) continue; - if (x(j,0) == xtmp && j <= i) continue; - } - } - } - if(exclude && exclusion(i,j,itype,jtype)) continue; + if(HalfNeigh && (j < i)) continue; + if(HalfNeigh && !Newton && (j < i)) continue; + if(!HalfNeigh && j==i) continue; + if(Tri) { + if (x(j,2) < ztmp) continue; + if (x(j,2) == ztmp) { + if (x(j,1) < ytmp) continue; + if (x(j,1) == ytmp) { + if (x(j,0) < xtmp) continue; + if (x(j,0) == xtmp && j <= i) continue; + } + } + } + if(exclude && exclusion(i,j,itype,jtype)) continue; - const X_FLOAT delx = xtmp - other_x[m]; - const X_FLOAT dely = ytmp - other_x[m + atoms_per_bin]; - const X_FLOAT delz = ztmp - other_x[m + 2 * atoms_per_bin]; - const X_FLOAT rsq = delx * delx + dely * dely + delz * delz; - const X_FLOAT radsum = radi + other_x[m + 4 * atoms_per_bin]; - const X_FLOAT cutsq = (radsum + skin) * (radsum + skin); + const X_FLOAT delx = xtmp - other_x[m]; + const X_FLOAT dely = ytmp - other_x[m + atoms_per_bin]; + const X_FLOAT delz = ztmp - other_x[m + 2 * atoms_per_bin]; + const X_FLOAT rsq = delx * delx + dely * dely + delz * delz; + const X_FLOAT radsum = radi + other_x[m + 4 * atoms_per_bin]; + const X_FLOAT cutsq = (radsum + skin) * (radsum + skin); - if(rsq <= cutsq) { - if(n::compute(int eflag_in, int vflag_in) if (lmp->kokkos->neighflag == HALF) { if (force->newton_pair) { if (vflag_atom) { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } else if (vflag_global) { - if (shearupdate) { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } else { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } + if (shearupdate) { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } else { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } } else { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } } else { if (vflag_atom) { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } else if (vflag_global) { - if (shearupdate) { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } else { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } + if (shearupdate) { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } else { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } } else { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } } } else { // HALFTHREAD if (force->newton_pair) { if (vflag_atom) { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } else if (vflag_global) { - if (shearupdate) { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } else { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } + if (shearupdate) { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } else { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } } else { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } } else { if (vflag_atom) { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } else if (vflag_global) { - if (shearupdate) { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } else { - Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); - } + if (shearupdate) { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } else { + Kokkos::parallel_reduce(Kokkos::RangePolicy>(0,inum),*this, ev); + } } else { - if (shearupdate) { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } else { - Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); - } + if (shearupdate) { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } else { + Kokkos::parallel_for(Kokkos::RangePolicy>(0,inum),*this); + } } } } @@ -408,7 +408,7 @@ void PairGranHookeHistoryKokkos::operator()(TagPairGranHookeHistoryC shear3 += vtr3*dt; } X_FLOAT shrmag = sqrt(shear1*shear1 + shear2*shear2 + - shear3*shear3); + shear3*shear3); // rotate shear displacements @@ -433,15 +433,15 @@ void PairGranHookeHistoryKokkos::operator()(TagPairGranHookeHistoryC if (fs > fn) { if (shrmag != 0.0) { - shear1 = (fn/fs) * (shear1 + meff*gammat*vtr1/kt) - - meff*gammat*vtr1/kt; - shear2 = (fn/fs) * (shear2 + meff*gammat*vtr2/kt) - - meff*gammat*vtr2/kt; - shear3 = (fn/fs) * (shear3 + meff*gammat*vtr3/kt) - - meff*gammat*vtr3/kt; - fs1 *= fn/fs; - fs2 *= fn/fs; - fs3 *= fn/fs; + shear1 = (fn/fs) * (shear1 + meff*gammat*vtr1/kt) - + meff*gammat*vtr1/kt; + shear2 = (fn/fs) * (shear2 + meff*gammat*vtr2/kt) - + meff*gammat*vtr2/kt; + shear3 = (fn/fs) * (shear3 + meff*gammat*vtr3/kt) - + meff*gammat*vtr3/kt; + fs1 *= fn/fs; + fs2 *= fn/fs; + fs3 *= fn/fs; } else fs1 = fs2 = fs3 = 0.0; } @@ -503,8 +503,8 @@ template template KOKKOS_INLINE_FUNCTION void PairGranHookeHistoryKokkos::ev_tally_xyz(EV_FLOAT &ev, int i, int j, - F_FLOAT fx, F_FLOAT fy, F_FLOAT fz, - X_FLOAT delx, X_FLOAT dely, X_FLOAT delz) const + F_FLOAT fx, F_FLOAT fy, F_FLOAT fz, + X_FLOAT delx, X_FLOAT dely, X_FLOAT delz) const { F_FLOAT v[6]; @@ -546,8 +546,8 @@ template template KOKKOS_INLINE_FUNCTION void PairGranHookeHistoryKokkos::ev_tally_xyz_atom(EV_FLOAT &ev, int i, int j, - F_FLOAT fx, F_FLOAT fy, F_FLOAT fz, - X_FLOAT delx, X_FLOAT dely, X_FLOAT delz) const + F_FLOAT fx, F_FLOAT fy, F_FLOAT fz, + X_FLOAT delx, X_FLOAT dely, X_FLOAT delz) const { Kokkos::View::value> > v_vatom = k_vatom.view(); diff --git a/src/KOKKOS/verlet_kokkos.cpp b/src/KOKKOS/verlet_kokkos.cpp index 23952b71d8..3367e97c6d 100644 --- a/src/KOKKOS/verlet_kokkos.cpp +++ b/src/KOKKOS/verlet_kokkos.cpp @@ -614,8 +614,8 @@ void VerletKokkos::force_clear() atomKK->modified(Device,F_MASK); if (torqueflag) { - Kokkos::parallel_for(range, Zero::t_f_array>(atomKK->k_torque.view())); - atomKK->modified(Device,TORQUE_MASK); + Kokkos::parallel_for(range, Zero::t_f_array>(atomKK->k_torque.view())); + atomKK->modified(Device,TORQUE_MASK); } } } diff --git a/src/KSPACE/ewald_disp.cpp b/src/KSPACE/ewald_disp.cpp index a24ee4203c..a7f0698c0c 100644 --- a/src/KSPACE/ewald_disp.cpp +++ b/src/KSPACE/ewald_disp.cpp @@ -131,7 +131,7 @@ void EwaldDisp::init() else if (ewald_mix==Pair::ARITHMETIC) { k = 2; break; } error->all(FLERR, "Unsupported mixing rule in kspace_style ewald/disp"); - break; + break; default: error->all(FLERR,"Unsupported order in kspace_style ewald/disp"); } diff --git a/src/KSPACE/pppm_disp.cpp b/src/KSPACE/pppm_disp.cpp index abc33b90fa..0d0d4c7eb2 100644 --- a/src/KSPACE/pppm_disp.cpp +++ b/src/KSPACE/pppm_disp.cpp @@ -320,8 +320,8 @@ void PPPMDisp::init() mixflag == 1) && mixflag!= 2) { k = 1; break; } else if (ewald_mix==Pair::ARITHMETIC && mixflag!=2) { k = 2; break; } else if (mixflag == 2) { k = 3; break; } - else error->all(FLERR,"Unsupported mixing rule in kspace_style pppm/disp"); - break; + else error->all(FLERR,"Unsupported mixing rule in kspace_style pppm/disp"); + break; default: sprintf(str, "Unsupported order in kspace_style " "pppm/disp, pair_style %s", force->pair_style); diff --git a/src/SPIN/atom_vec_spin.h b/src/SPIN/atom_vec_spin.h index 1f1c34df52..a31e57bb48 100644 --- a/src/SPIN/atom_vec_spin.h +++ b/src/SPIN/atom_vec_spin.h @@ -67,13 +67,13 @@ class AtomVecSpin : public AtomVec { tagint *tag; int *type,*mask; imageint *image; - double **x,**v,**f; // lattice quantities + double **x,**v,**f; // lattice quantities - // spin quantities - double **sp; // sp[i][0-2] direction of the spin i - // sp[i][3] atomic magnetic moment of the spin i - double **fm; // fm[i][0-2] direction of magnetic precession - double **fm_long; // storage of long-range spin prec. components + // spin quantities + double **sp; // sp[i][0-2] direction of the spin i + // sp[i][3] atomic magnetic moment of the spin i + double **fm; // fm[i][0-2] direction of magnetic precession + double **fm_long; // storage of long-range spin prec. components }; } diff --git a/src/SPIN/fix_langevin_spin.h b/src/SPIN/fix_langevin_spin.h index 5358438396..b581b70d34 100644 --- a/src/SPIN/fix_langevin_spin.h +++ b/src/SPIN/fix_langevin_spin.h @@ -32,17 +32,17 @@ class FixLangevinSpin : public Fix { void init(); void setup(int); void post_force_respa(int, int, int); - void add_tdamping(double spi[3], double fmi[3]); // add transverse damping - void add_temperature(double fmi[3]); // add temperature - int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags + void add_tdamping(double spi[3], double fmi[3]); // add transverse damping + void add_temperature(double fmi[3]); // add temperature + int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags protected: double *spi, *fmi; - double alpha_t; // transverse mag. damping - double dts; // magnetic timestep - double temp; // spin bath temperature - double D,sigma; // bath intensity var. - double gil_factor; // gilbert's prefactor + double alpha_t; // transverse mag. damping + double dts; // magnetic timestep + double temp; // spin bath temperature + double D,sigma; // bath intensity var. + double gil_factor; // gilbert's prefactor char *id_temp; class Compute *temperature; diff --git a/src/SPIN/fix_neb_spin.h b/src/SPIN/fix_neb_spin.h index 7ac83ddce7..9646684a3a 100644 --- a/src/SPIN/fix_neb_spin.h +++ b/src/SPIN/fix_neb_spin.h @@ -60,20 +60,20 @@ class FixNEBSpin : public Fix { double **spprev,**spnext,**fmnext; double **springF; double **tangent; - double **xsend,**xrecv; // coords to send/recv to/from other replica - double **fsend,**frecv; // coords to send/recv to/from other replica - double **spsend,**sprecv; // sp to send/recv to/from other replica - double **fmsend,**fmrecv; // fm to send/recv to/from other replica - tagint *tagsend,*tagrecv; // ditto for atom IDs + double **xsend,**xrecv; // coords to send/recv to/from other replica + double **fsend,**frecv; // coords to send/recv to/from other replica + double **spsend,**sprecv; // sp to send/recv to/from other replica + double **fmsend,**fmrecv; // fm to send/recv to/from other replica + tagint *tagsend,*tagrecv; // ditto for atom IDs - // info gathered from all procs in my replica - double **xsendall,**xrecvall; // coords to send/recv to/from other replica - double **fsendall,**frecvall; // force to send/recv to/from other replica - double **spsendall,**sprecvall; // sp to send/recv to/from other replica - double **fmsendall,**fmrecvall; // fm to send/recv to/from other replica - tagint *tagsendall,*tagrecvall; // ditto for atom IDs + // info gathered from all procs in my replica + double **xsendall,**xrecvall; // coords to send/recv to/from other replica + double **fsendall,**frecvall; // force to send/recv to/from other replica + double **spsendall,**sprecvall; // sp to send/recv to/from other replica + double **fmsendall,**fmrecvall; // fm to send/recv to/from other replica + tagint *tagsendall,*tagrecvall; // ditto for atom IDs - int *counts,*displacements; // used for MPI_Gather + int *counts,*displacements; // used for MPI_Gather double geodesic_distance(double *, double *); void inter_replica_comm(); diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index 9b4f1916ae..87546ba9da 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -307,7 +307,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = forward_stacks[i]; - } + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal @@ -318,7 +318,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = backward_stacks[i]; - } + } } } } else if (sector_flag == 0) { // serial seq. update @@ -360,7 +360,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = forward_stacks[i]; - } + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal @@ -371,7 +371,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = backward_stacks[i]; - } + } } } } else if (sector_flag == 0) { // serial seq. update diff --git a/src/SPIN/fix_nve_spin.h b/src/SPIN/fix_nve_spin.h index 5871f721be..5aa6b8e4e4 100644 --- a/src/SPIN/fix_nve_spin.h +++ b/src/SPIN/fix_nve_spin.h @@ -34,30 +34,30 @@ friend class PairSpin; virtual void initial_integrate(int); virtual void final_integrate(); - void ComputeInteractionsSpin(int); // compute and advance single spin functions + void ComputeInteractionsSpin(int); // compute and advance single spin functions void AdvanceSingleSpin(int); - void sectoring(); // sectoring operation functions + void sectoring(); // sectoring operation functions int coords2sector(double *); void setup_pre_neighbor(); void pre_neighbor(); - int lattice_flag; // lattice_flag = 0 if spins only - // lattice_flag = 1 if spin-lattice calc. + int lattice_flag; // lattice_flag = 0 if spins only + // lattice_flag = 1 if spin-lattice calc. protected: - int sector_flag; // sector_flag = 0 if serial algorithm - // sector_flag = 1 if parallel algorithm + int sector_flag; // sector_flag = 0 if serial algorithm + // sector_flag = 1 if parallel algorithm - double dtv, dtf, dts; // velocity, force, and spin timesteps + double dtv, dtf, dts; // velocity, force, and spin timesteps - int nlocal_max; // max value of nlocal (for size of lists) + int nlocal_max; // max value of nlocal (for size of lists) - int pair_spin_flag; // magnetic pair flags - int long_spin_flag; // magnetic long-range flag - int precession_spin_flag; // magnetic precession flags - int maglangevin_flag; // magnetic langevin flags + int pair_spin_flag; // magnetic pair flags + int long_spin_flag; // magnetic long-range flag + int precession_spin_flag; // magnetic precession flags + int maglangevin_flag; // magnetic langevin flags int tdamp_flag, temp_flag; int setforce_spin_flag; @@ -69,9 +69,9 @@ friend class PairSpin; // pointers to magnetic pair styles - int npairs, npairspin; // # of pairs, and # of spin pairs + int npairs, npairspin; // # of pairs, and # of spin pairs class Pair *pair; - class PairSpin **spin_pairs; // vector of spin pairs + class PairSpin **spin_pairs; // vector of spin pairs // sectoring variables @@ -80,10 +80,10 @@ friend class PairSpin; // stacking variables for sectoring algorithm - int *stack_head; // index of first atom in backward_stacks - int *stack_foot; // index of first atom in forward_stacks - int *backward_stacks; // index of next atom in backward stack - int *forward_stacks; // index of next atom in forward stack + int *stack_head; // index of first atom in backward_stacks + int *stack_foot; // index of first atom in forward_stacks + int *backward_stacks; // index of next atom in backward stack + int *forward_stacks; // index of next atom in forward stack }; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 3296b28228..97dbe7ba6f 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -236,7 +236,7 @@ void FixPrecessionSpin::post_force(int /* vflag */) if (varflag != CONSTANT) { modify->clearstep_compute(); modify->addstep_compute(update->ntimestep + 1); - set_magneticprecession(); // update mag. field if time-dep. + set_magneticprecession(); // update mag. field if time-dep. } int *mask = atom->mask; @@ -265,9 +265,9 @@ void FixPrecessionSpin::post_force(int /* vflag */) epreci -= compute_anisotropy_energy(spi); } - if (cubic_flag) { // compute cubic anisotropy - compute_cubic(spi,fmi); - epreci -= compute_cubic_energy(spi); + if (cubic_flag) { // compute cubic anisotropy + compute_cubic(spi,fmi); + epreci -= compute_cubic_energy(spi); } eprec += epreci; diff --git a/src/SPIN/fix_precession_spin.h b/src/SPIN/fix_precession_spin.h index 0037784a48..96d89e004e 100644 --- a/src/SPIN/fix_precession_spin.h +++ b/src/SPIN/fix_precession_spin.h @@ -54,7 +54,7 @@ class FixPrecessionSpin : public Fix { double compute_cubic_energy(double *); protected: - int style; // style of the magnetic precession + int style; // style of the magnetic precession double degree2rad; double hbar; @@ -72,19 +72,19 @@ class FixPrecessionSpin : public Fix { double H_field; double nhx, nhy, nhz; - double hx, hy, hz; // temp. force variables + double hx, hy, hz; // temp. force variables // magnetic anisotropy intensity and direction - double Ka; // aniso const. in eV - double Kah; // aniso const. in rad.THz + double Ka; // aniso const. in eV + double Kah; // aniso const. in rad.THz double nax, nay, naz; - double Kax, Kay, Kaz; // temp. force variables + double Kax, Kay, Kaz; // temp. force variables // cubic anisotropy intensity - double k1c,k2c; // cubic const. in eV - double k1ch,k2ch; // cubic const. in rad.THz + double k1c,k2c; // cubic const. in eV + double k1ch,k2ch; // cubic const. in rad.THz double nc1x,nc1y,nc1z; double nc2x,nc2y,nc2z; double nc3x,nc3y,nc3z; diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 7315aca056..e39eb18744 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -165,9 +165,9 @@ int MinSpin::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { diff --git a/src/SPIN/min_spin_cg.cpp b/src/SPIN/min_spin_cg.cpp index 95bbcf437b..9c8c814bc4 100644 --- a/src/SPIN/min_spin_cg.cpp +++ b/src/SPIN/min_spin_cg.cpp @@ -270,9 +270,9 @@ int MinSpinCG::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { @@ -347,12 +347,12 @@ void MinSpinCG::calc_search_direction() factor = 0.0; - if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i] * factor; g_old[i] = g_cur[i] * factor; } - } else { // conjugate direction + } else { // conjugate direction for (int i = 0; i < 3 * nlocal; i++) { g2old += g_old[i] * g_old[i]; g2 += g_cur[i] * g_cur[i]; @@ -394,7 +394,7 @@ void MinSpinCG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; - double rot_mat[9]; // exponential of matrix made of search direction + double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; // loop on all spins on proc. diff --git a/src/SPIN/min_spin_cg.h b/src/SPIN/min_spin_cg.h index 0eed7a61e6..640721b8ef 100644 --- a/src/SPIN/min_spin_cg.h +++ b/src/SPIN/min_spin_cg.h @@ -35,21 +35,21 @@ class MinSpinCG: public Min { int iterate(int); private: - int local_iter; // for neb - int nlocal_max; // max value of nlocal (for size of lists) - int use_line_search; // use line search or not. - int ireplica,nreplica; // for neb - double dt; // global timestep - double dts; // spin timestep - double discrete_factor; // factor for spin timestep evaluation - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector - double **sp_copy; // copy of the spins + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + int use_line_search; // use line search or not. + int ireplica,nreplica; // for neb + double dt; // global timestep + double dts; // spin timestep + double discrete_factor; // factor for spin timestep evaluation + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector + double **sp_copy; // copy of the spins void advance_spins(); void calc_gradient(); diff --git a/src/SPIN/min_spin_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp index f86bdd5d48..a1ee010f3f 100644 --- a/src/SPIN/min_spin_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -285,9 +285,9 @@ int MinSpinLBFGS::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { @@ -372,7 +372,7 @@ void MinSpinLBFGS::calc_search_direction() factor = 1.0; } - if (local_iter == 0){ // steepest descent direction + if (local_iter == 0){ // steepest descent direction //if no line search then calculate maximum rotation if (use_line_search == 0) diff --git a/src/SPIN/min_spin_lbfgs.h b/src/SPIN/min_spin_lbfgs.h index cead605b32..8b470b5d23 100644 --- a/src/SPIN/min_spin_lbfgs.h +++ b/src/SPIN/min_spin_lbfgs.h @@ -35,18 +35,18 @@ class MinSpinLBFGS: public Min { int iterate(int); private: - int local_iter; // for neb - int use_line_search; // use line search or not. - int nlocal_max; // max value of nlocal (for size of lists) - int ireplica,nreplica; // for neb - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. + int local_iter; // for neb + int use_line_search; // use line search or not. + int nlocal_max; // max value of nlocal (for size of lists) + int ireplica,nreplica; // for neb + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. double maxepsrot; - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector void advance_spins(); void calc_gradient(); @@ -58,11 +58,11 @@ class MinSpinLBFGS: public Min { int adescent(double, double); double maximum_rotation(double *); - double *rho; // estimation of curvature - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg - double **sp_copy; // copy of the spins - int num_mem; // number of stored steps + double *rho; // estimation of curvature + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double **sp_copy; // copy of the spins + int num_mem; // number of stored steps bigint last_negative; }; diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 559fd1cb49..075850d1af 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -179,7 +179,7 @@ void NEBSpin::run() update->whichflag = 2; update->etol = etol; - update->ftol = ttol; // update->ftol is a torque tolerance + update->ftol = ttol; // update->ftol is a torque tolerance update->multireplica = 1; lmp->init(); @@ -214,7 +214,7 @@ void NEBSpin::run() fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT " "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT RD1 PE1 RD2 PE2 ... " @@ -224,10 +224,10 @@ void NEBSpin::run() if (ulogfile) { if (verbose) { - fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " - "GradV0 GradV1 GradVc EBF EBR RDT " - "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " + "GradV0 GradV1 GradVc EBF EBR RDT " + "RD1 PE1 RD2 PE2 ... RDN PEN " + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT RD1 PE1 RD2 PE2 ... " @@ -301,7 +301,7 @@ void NEBSpin::run() fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT " "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0... GradVNdottan DNN\n"); + "GradV0dottan DN0... GradVNdottan DNN\n"); } else { fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc " @@ -311,10 +311,10 @@ void NEBSpin::run() } if (ulogfile) { if (verbose) { - fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " - "GradV0 GradV1 GradVc EBF EBR RDT " - "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " + "GradV0 GradV1 GradVc EBF EBR RDT " + "RD1 PE1 RD2 PE2 ... RDN PEN " + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc " @@ -472,8 +472,8 @@ void NEBSpin::readfile(char *file, int flag) m = atom->map(tag); if (m >= 0 && m < nlocal) { ncount++; - musp = atof(values[1]); - xx = atof(values[2]); + musp = atof(values[1]); + xx = atof(values[2]); yy = atof(values[3]); zz = atof(values[4]); spx = atof(values[5]); @@ -482,39 +482,39 @@ void NEBSpin::readfile(char *file, int flag) if (flag == 0) { - spinit[0] = sp[m][0]; - spinit[1] = sp[m][1]; - spinit[2] = sp[m][2]; - spfinal[0] = spx; - spfinal[1] = spy; - spfinal[2] = spz; + spinit[0] = sp[m][0]; + spinit[1] = sp[m][1]; + spinit[2] = sp[m][2]; + spfinal[0] = spx; + spfinal[1] = spy; + spfinal[2] = spz; - // interpolate intermediate spin states + // interpolate intermediate spin states - sp[m][3] = musp; - if (fraction == 0.0) { - sp[m][0] = spinit[0]; - sp[m][1] = spinit[1]; - sp[m][2] = spinit[2]; - } else if (fraction == 1.0) { - sp[m][0] = spfinal[0]; - sp[m][1] = spfinal[1]; - sp[m][2] = spfinal[2]; - } else { + sp[m][3] = musp; + if (fraction == 0.0) { + sp[m][0] = spinit[0]; + sp[m][1] = spinit[1]; + sp[m][2] = spinit[2]; + } else if (fraction == 1.0) { + sp[m][0] = spfinal[0]; + sp[m][1] = spfinal[1]; + sp[m][2] = spfinal[2]; + } else { temp_flag = initial_rotation(spinit,spfinal,fraction); rot_flag = MAX(temp_flag,rot_flag); - sp[m][0] = spfinal[0]; - sp[m][1] = spfinal[1]; - sp[m][2] = spfinal[2]; - } + sp[m][0] = spfinal[0]; + sp[m][1] = spfinal[1]; + sp[m][2] = spfinal[2]; + } } else { sp[m][3] = musp; - x[m][0] = xx; + x[m][0] = xx; x[m][1] = yy; x[m][2] = zz; - sp[m][0] = spx; - sp[m][1] = spy; - sp[m][2] = spz; + sp[m][0] = spx; + sp[m][1] = spy; + sp[m][2] = spz; } } @@ -602,24 +602,24 @@ int NEBSpin::initial_rotation(double *spi, double *sploc, double fraction) // Rodrigues' formula breaks, needs to define another axis k if (knormsq == 0.0) { - if (sidotsf > 0.0) { // spins aligned and in same direction + if (sidotsf > 0.0) { // spins aligned and in same direction return 0; - } else if (sidotsf < 0.0) { // spins aligned and in opposite directions + } else if (sidotsf < 0.0) { // spins aligned and in opposite directions // defining a rotation axis // first guess, k = spi x [100] // second guess, k = spi x [010] if (spiy*spiy + spiz*spiz != 0.0) { // spin not along [100] - kx = 0.0; - ky = spiz; - kz = -spiy; - knormsq = ky*ky + kz*kz; + kx = 0.0; + ky = spiz; + kz = -spiy; + knormsq = ky*ky + kz*kz; } else if (spix*spix + spiz*spiz != 0.0) { // spin not along [010] - kx = -spiz; - ky = 0.0; - kz = spix; - knormsq = kx*kx + kz*kz; + kx = -spiz; + ky = 0.0; + kz = spix; + knormsq = kx*kx + kz*kz; } else error->all(FLERR,"Incorrect initial rotation operation"); rot_flag = 1; } @@ -822,9 +822,9 @@ void NEBSpin::print_status() for (int i = 0; i < nreplica; i++) fprintf(uscreen,"%12.8g %12.8g ",rdist[i],all[i][0]); if (verbose) { - for (int i = 0; i < nreplica-1; i++) - fprintf(uscreen,"%12.8g %12.8g ",all[i][2],all[i][5]); - fprintf(uscreen,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); + for (int i = 0; i < nreplica-1; i++) + fprintf(uscreen,"%12.8g %12.8g ",all[i][2],all[i][5]); + fprintf(uscreen,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); } fprintf(uscreen,"\n"); } @@ -838,9 +838,9 @@ void NEBSpin::print_status() for (int i = 0; i < nreplica; i++) fprintf(ulogfile,"%12.8g %12.8g ",rdist[i],all[i][0]); if (verbose) { - for (int i = 0; i < nreplica-1; i++) - fprintf(ulogfile,"%12.8g %12.8g ",all[i][2],all[i][5]); - fprintf(ulogfile,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); + for (int i = 0; i < nreplica-1; i++) + fprintf(ulogfile,"%12.8g %12.8g ",all[i][2],all[i][5]); + fprintf(ulogfile,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); } fprintf(ulogfile,"\n"); fflush(ulogfile); diff --git a/src/SPIN/pair_spin.h b/src/SPIN/pair_spin.h index 0111814c72..34f12d8d59 100644 --- a/src/SPIN/pair_spin.h +++ b/src/SPIN/pair_spin.h @@ -33,8 +33,8 @@ friend class FixNVESpin; virtual void compute_single_pair(int, double *) {} protected: - double hbar; // Planck constant (eV.ps.rad-1) - int lattice_flag; // flag for mech force computation + double hbar; // Planck constant (eV.ps.rad-1) + int lattice_flag; // flag for mech force computation virtual void allocate() {} }; diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index 4ff90323f2..bae09689de 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -46,11 +46,11 @@ PairSpinDipoleCut::PairSpinDipoleCut(LAMMPS *lmp) : PairSpin(lmp) { spinflag = 1; - 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 + //mub2mu0 = mub * mub * mu_0 / (4.0*MY_PI); // in eV mub2mu0hbinv = mub2mu0 / hbar; // in rad.THz } @@ -178,7 +178,7 @@ void PairSpinDipoleCut::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; inum = list->inum; ilist = list->ilist; @@ -228,36 +228,36 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) if (rsq < local_cut2) { r2inv = 1.0/rsq; - r3inv = r2inv*rinv; - - compute_dipolar(i,j,eij,fmi,spi,spj,r3inv); - if (lattice_flag) compute_dipolar_mech(i,j,eij,fi,spi,spj,r2inv); + r3inv = r2inv*rinv; + + compute_dipolar(i,j,eij,fmi,spi,spj,r3inv); + if (lattice_flag) compute_dipolar_mech(i,j,eij,fi,spi,spj,r2inv); } // force accumulation f[i][0] += fi[0]; - f[i][1] += fi[1]; + f[i][1] += fi[1]; f[i][2] += fi[2]; 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]); } } @@ -277,7 +277,7 @@ void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) int k,locflag; int *type = atom->type; double **x = atom->x; - double **sp = atom->sp; + double **sp = atom->sp; numneigh = list->numneigh; firstneigh = list->firstneigh; @@ -427,7 +427,7 @@ void PairSpinDipoleCut::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); } } } @@ -450,10 +450,10 @@ void PairSpinDipoleCut::read_restart(FILE *fp) if (me == 0) utils::sfread(FLERR,&setflag[i][j],sizeof(int),1,fp,NULL,error); MPI_Bcast(&setflag[i][j],1,MPI_INT,0,world); if (setflag[i][j]) { - if (me == 0) { - utils::sfread(FLERR,&cut_spin_long[i][j],sizeof(int),1,fp,NULL,error); - } - MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); + if (me == 0) { + utils::sfread(FLERR,&cut_spin_long[i][j],sizeof(int),1,fp,NULL,error); + } + MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); } } } diff --git a/src/SPIN/pair_spin_dipole_cut.h b/src/SPIN/pair_spin_dipole_cut.h index f9159a629f..33f62d1633 100644 --- a/src/SPIN/pair_spin_dipole_cut.h +++ b/src/SPIN/pair_spin_dipole_cut.h @@ -49,16 +49,16 @@ class PairSpinDipoleCut : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_long_global; // global long cutoff distance + double cut_spin_long_global; // global long cutoff distance protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton - double mu_0; // vacuum permeability - double mub2mu0; // prefactor for mech force - double mub2mu0hbinv; // prefactor for mag force + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton + double mu_0; // vacuum permeability + double mub2mu0; // prefactor for mech force + double mub2mu0hbinv; // prefactor for mag force - double **cut_spin_long; // cutoff distance long + double **cut_spin_long; // cutoff distance long double g_ewald; int ewald_order; diff --git a/src/SPIN/pair_spin_dipole_long.h b/src/SPIN/pair_spin_dipole_long.h index 1997cbbc55..56fd4c7126 100644 --- a/src/SPIN/pair_spin_dipole_long.h +++ b/src/SPIN/pair_spin_dipole_long.h @@ -50,16 +50,16 @@ class PairSpinDipoleLong : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_long_global; // global long cutoff distance + double cut_spin_long_global; // global long cutoff distance protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton - double mu_0; // vacuum permeability - double mub2mu0; // prefactor for mech force - double mub2mu0hbinv; // prefactor for mag force + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton + double mu_0; // vacuum permeability + double mub2mu0; // prefactor for mech force + double mub2mu0hbinv; // prefactor for mag force - double **cut_spin_long; // cutoff distance long + double **cut_spin_long; // cutoff distance long double g_ewald; int ewald_order; diff --git a/src/SPIN/pair_spin_dmi.h b/src/SPIN/pair_spin_dmi.h index ac2aa387b3..01022623ec 100644 --- a/src/SPIN/pair_spin_dmi.h +++ b/src/SPIN/pair_spin_dmi.h @@ -44,13 +44,13 @@ class PairSpinDmi : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_dmi_global; // short range pair cutoff + double cut_spin_dmi_global; // short range pair cutoff protected: - double **DM; // dmi coeff in eV - double **v_dmx, **v_dmy, **v_dmz; // dmi direction - double **vmech_dmx, **vmech_dmy, **vmech_dmz; // dmi mech direction - double **cut_spin_dmi; // cutoff distance dmi + double **DM; // dmi coeff in eV + double **v_dmx, **v_dmy, **v_dmz; // dmi direction + double **vmech_dmx, **vmech_dmy, **vmech_dmz; // dmi mech direction + double **cut_spin_dmi; // cutoff distance dmi void allocate(); }; diff --git a/src/SPIN/pair_spin_exchange.h b/src/SPIN/pair_spin_exchange.h index 5feb99210f..19eafeb5ca 100644 --- a/src/SPIN/pair_spin_exchange.h +++ b/src/SPIN/pair_spin_exchange.h @@ -44,13 +44,13 @@ class PairSpinExchange : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_exchange_global; // global exchange cutoff distance + double cut_spin_exchange_global; // global exchange cutoff distance protected: - double **J1_mag; // exchange coeffs in eV - double **J1_mech; // mech exchange coeffs in + double **J1_mag; // exchange coeffs in eV + double **J1_mech; // mech exchange coeffs in double **J2, **J3; // J1 in eV, J2 adim, J3 in Ang - double **cut_spin_exchange; // cutoff distance exchange + double **cut_spin_exchange; // cutoff distance exchange void allocate(); }; diff --git a/src/SPIN/pair_spin_magelec.h b/src/SPIN/pair_spin_magelec.h index b9e820b1d1..4df0078bea 100644 --- a/src/SPIN/pair_spin_magelec.h +++ b/src/SPIN/pair_spin_magelec.h @@ -44,12 +44,12 @@ class PairSpinMagelec : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_magelec_global; // global me cutoff + double cut_spin_magelec_global; // global me cutoff protected: - double **ME, **ME_mech; // magelec coeff in eV - double **v_mex, **v_mey, **v_mez; // magelec direction - double **cut_spin_magelec; // magelec cutoff distance + double **ME, **ME_mech; // magelec coeff in eV + double **v_mex, **v_mey, **v_mez; // magelec direction + double **cut_spin_magelec; // magelec cutoff distance void allocate(); }; diff --git a/src/SPIN/pair_spin_neel.h b/src/SPIN/pair_spin_neel.h index 796d8b53f0..5261a7f746 100644 --- a/src/SPIN/pair_spin_neel.h +++ b/src/SPIN/pair_spin_neel.h @@ -44,17 +44,17 @@ class PairSpinNeel : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_neel_global; // global neel cutoff distance + double cut_spin_neel_global; // global neel cutoff distance protected: // pseudo-dipolar and pseudo-quadrupolar coeff. - double **g1, **g1_mech; // neel coeffs gij - double **g2, **g3; // g1 in eV, g2 adim, g3 in Ang - double **q1, **q1_mech; // neel coeffs qij - double **q2, **q3; // q1 in eV, q2 adim, q3 in Ang - double **cut_spin_neel; // cutoff distance exchange + double **g1, **g1_mech; // neel coeffs gij + double **g2, **g3; // g1 in eV, g2 adim, g3 in Ang + double **q1, **q1_mech; // neel coeffs qij + double **q2, **q3; // q1 in eV, q2 adim, q3 in Ang + double **cut_spin_neel; // cutoff distance exchange void allocate(); }; diff --git a/src/USER-MISC/compute_hma.cpp b/src/USER-MISC/compute_hma.cpp index f1c2e9ba3a..56103a42b0 100644 --- a/src/USER-MISC/compute_hma.cpp +++ b/src/USER-MISC/compute_hma.cpp @@ -457,7 +457,7 @@ double ComputeHMA::virial_compute(int n) /* ---------------------------------------------------------------------- */ int ComputeHMA::pack_forward_comm(int n, int *list, double *buf, - int /* pbc_flag */, int * /* pbc */) + int /* pbc_flag */, int * /* pbc */) { int m = 0; for (int ii = 0; ii < n; ii++) { diff --git a/src/USER-MISC/fix_bond_react.cpp b/src/USER-MISC/fix_bond_react.cpp index bfa93e178c..33aab5b4ad 100644 --- a/src/USER-MISC/fix_bond_react.cpp +++ b/src/USER-MISC/fix_bond_react.cpp @@ -259,12 +259,12 @@ FixBondReact::FixBondReact(LAMMPS *lmp, int narg, char **arg) : "probability seed must be positive"); iarg += 3; } else if (strcmp(arg[iarg],"max_rxn") == 0) { - if (iarg+2 > narg) error->all(FLERR,"Illegal fix bond/react command: " - "'max_rxn' has too few arguments"); - max_rxn[rxn] = force->inumeric(FLERR,arg[iarg+1]); - if (max_rxn[rxn] < 0) error->all(FLERR,"Illegal fix bond/react command: " - "'max_rxn' cannot be negative"); - iarg += 2; + if (iarg+2 > narg) error->all(FLERR,"Illegal fix bond/react command: " + "'max_rxn' has too few arguments"); + max_rxn[rxn] = force->inumeric(FLERR,arg[iarg+1]); + if (max_rxn[rxn] < 0) error->all(FLERR,"Illegal fix bond/react command: " + "'max_rxn' cannot be negative"); + iarg += 2; } else if (strcmp(arg[iarg],"stabilize_steps") == 0) { if (stabilization_flag == 0) error->all(FLERR,"Stabilize_steps keyword " "used without stabilization keyword"); diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp index e09287ae23..9faa350468 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp +++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp @@ -523,7 +523,7 @@ void PairILPGrapheneHBN::calc_FvdW(int eflag, int /* vflag */) // 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; + fsum = fpair*Tap - Vilp*dTap/r; f[i][0] += fsum*delx; f[i][1] += fsum*dely; @@ -634,12 +634,12 @@ void PairILPGrapheneHBN::calc_FRep(int eflag, int /* vflag */) 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; + 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 - Vilp*dTap*delx/r; fkcy = (dely*fsum - fp1[1])*Tap - Vilp*dTap*dely/r; diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp index 8ba3dc9db3..d0d8517550 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp @@ -519,11 +519,11 @@ void PairKolmogorovCrespiFull::calc_FvdW(int eflag, int /* vflag */) dTap = calc_dTap(r,Rcut); } else {Tap = 1.0; dTap = 0.0;} - Vkc = -p.A*p.z06*r6inv; + Vkc = -p.A*p.z06*r6inv; // derivatives fpair = -6.0*p.A*p.z06*r8inv; - fsum = fpair*Tap - Vkc*dTap/r; + fsum = fpair*Tap - Vkc*dTap/r; f[i][0] += fsum*delx; f[i][1] += fsum*dely; @@ -607,11 +607,11 @@ void PairKolmogorovCrespiFull::calc_FRep(int eflag, int /* vflag */) r = sqrt(rsq); - // 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;} + // 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;} // Calculate the transverse distance prodnorm1 = normal[i][0]*delx + normal[i][1]*dely + normal[i][2]*delz; @@ -626,7 +626,7 @@ void PairKolmogorovCrespiFull::calc_FRep(int eflag, int /* vflag */) 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; + Vkc = exp0*sumCff; // derivatives fpair = p.lambda*exp0/r*sumCff; @@ -653,10 +653,10 @@ void PairKolmogorovCrespiFull::calc_FRep(int eflag, int /* vflag */) f[j][1] -= fkcy; f[j][2] -= fkcz; - // 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]; + // 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; @@ -672,7 +672,7 @@ void PairKolmogorovCrespiFull::calc_FRep(int eflag, int /* vflag */) 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 (eflag) { if (tap_flag) pvector[1] += evdwl = Tap*Vkc; @@ -790,7 +790,7 @@ void PairKolmogorovCrespiFull::calc_normal() memory->create(dnormal,3,3,3,nmax,"KolmogorovCrespiFull:dnormal"); } - inum = list->inum; + inum = list->inum; ilist = list->ilist; //Calculate normals for (ii = 0; ii < inum; ii++) { diff --git a/src/USER-MISC/pair_lj_expand_coul_long.cpp b/src/USER-MISC/pair_lj_expand_coul_long.cpp index 957173bf7f..f52e427c18 100644 --- a/src/USER-MISC/pair_lj_expand_coul_long.cpp +++ b/src/USER-MISC/pair_lj_expand_coul_long.cpp @@ -786,9 +786,9 @@ double PairLJExpandCoulLong::init_one(int i, int j) (1.0/3.0 + 2.0*shift1/(4.0*rc1) + shift2/(5.0*rc2))/rc3); ptail_ij = 16.0*MY_PI*all[0]*all[1]*epsilon[i][j] * sig6 * ((1.0/9.0 + 3.0*shift1/(10.0*rc1) + - 3.0*shift2/(11.0*rc2) + shift3/(12.0*rc3))*2.0*sig6/rc9 - + 3.0*shift2/(11.0*rc2) + shift3/(12.0*rc3))*2.0*sig6/rc9 - (1.0/3.0 + 3.0*shift1/(4.0*rc1) + - 3.0*shift2/(5.0*rc2) + shift3/(6.0*rc3))/rc3); + 3.0*shift2/(5.0*rc2) + shift3/(6.0*rc3))/rc3); } return cut; diff --git a/src/USER-MISC/pair_local_density.cpp b/src/USER-MISC/pair_local_density.cpp index 97aa3dcaca..1e4ad3edf6 100644 --- a/src/USER-MISC/pair_local_density.cpp +++ b/src/USER-MISC/pair_local_density.cpp @@ -61,7 +61,7 @@ static const char cite_pair_local_density[] = PairLocalDensity::PairLocalDensity(LAMMPS *lmp) : Pair(lmp) { restartinfo = 0; - one_coeff = 1; + one_coeff = 1; single_enable = 1; // stuff read from tabulated file @@ -117,7 +117,7 @@ PairLocalDensity::~PairLocalDensity() memory->destroy(rho_min); memory->destroy(rho_max); - memory->destroy(delta_rho); + memory->destroy(delta_rho); memory->destroy(c0); memory->destroy(c2); memory->destroy(c4); @@ -144,7 +144,7 @@ void PairLocalDensity::compute(int eflag, int vflag) double p, *coeff; int *ilist,*jlist,*numneigh,**firstneigh; - phi = uLD = evdwl = fpair = rsqinv = 0.0; + phi = uLD = evdwl = fpair = rsqinv = 0.0; if (eflag || vflag) ev_setup(eflag,vflag); else evflag = vflag_fdotr = eflag_global = eflag_atom = 0; @@ -180,11 +180,11 @@ void PairLocalDensity::compute(int eflag, int vflag) if (newton_pair) { m = nlocal + atom->nghost; for (k = 0; k < nLD; k++) { - for (i = 0; i < m; i++) { + for (i = 0; i < m; i++) { localrho[k][i] = 0.0; fp[k][i] = 0.0; } - } + } } else { for (k = 0; k < nLD; k++){ @@ -209,14 +209,14 @@ void PairLocalDensity::compute(int eflag, int vflag) for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - jtype = type[j]; + jtype = type[j]; // calculate distance-squared between i,j atom-types delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; + rsq = delx*delx + dely*dely + delz*delz; // calculating LDs based on central and neigh filters @@ -239,7 +239,7 @@ void PairLocalDensity::compute(int eflag, int vflag) localrho[k][j] += (phi * b[k][itype]); } } - } + } } // communicate and sum LDs over all procs @@ -247,10 +247,10 @@ void PairLocalDensity::compute(int eflag, int vflag) // - for (ii = 0; ii < inum; ii++) { + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; itype = type[i]; - uLD = 0.0; + uLD = 0.0; for (k = 0; k < nLD; k++) { @@ -284,7 +284,7 @@ void PairLocalDensity::compute(int eflag, int vflag) if (eflag) { if (eflag_global) eng_vdwl += uLD; - if (eflag_atom) eatom[i] += uLD; + if (eflag_atom) eatom[i] += uLD; } } @@ -306,7 +306,7 @@ void PairLocalDensity::compute(int eflag, int vflag) jnum = numneigh[i]; for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; + j = jlist[jj]; j &= NEIGHMASK; jtype = type[j]; @@ -326,7 +326,7 @@ void PairLocalDensity::compute(int eflag, int vflag) dphi = rsq * (2.0*c2[k] + rsq * (4.0*c4[k] + 6.0*c6[k]*rsq)); fpair += -(a[k][itype]*b[k][jtype]*fp[k][i] + a[k][jtype]*b[k][itype]*fp[k][j]) * dphi; } - } + } fpair *= rsqinv; f[i][0] += delx*fpair; @@ -459,8 +459,8 @@ double PairLocalDensity::init_one(int /* i */, int /* j */) ---------------------------------------------------------------------------*/ double PairLocalDensity::single(int /* i */, int /* j */, int itype, int jtype, - double rsq, double /* factor_coul */, - double /* factor_lj */, double &fforce) + double rsq, double /* factor_coul */, + double /* factor_lj */, double &fforce) { int m, k, index; double rsqinv, p, uLD; @@ -473,7 +473,7 @@ double PairLocalDensity::single(int /* i */, int /* j */, int itype, int jtype, for (k = 0; k < nLD; k++) { LD[k][1] = 0.0; // itype:- 1 LD[k][2] = 0.0; // jtype:- 2 - } + } rsqinv = 1.0/rsq; for (k = 0; k < nLD; k++) { @@ -556,24 +556,24 @@ void PairLocalDensity::interpolate_cbspl(int n, double delta, { /* inputs: n number of interpolating points - - f array containing function values to - be interpolated; f[i] is the function - value corresponding to x[i] - ('x' refers to the independent var) - - delta difference in tabulated values of x + + f array containing function values to + be interpolated; f[i] is the function + value corresponding to x[i] + ('x' refers to the independent var) + + delta difference in tabulated values of x - outputs: (packaged as columns of the coeff matrix) - coeff_b coeffs of linear terms - coeff_c coeffs of quadratic terms - coeff_d coeffs of cubic terms + outputs: (packaged as columns of the coeff matrix) + coeff_b coeffs of linear terms + coeff_c coeffs of quadratic terms + coeff_d coeffs of cubic terms spline matrix that collects b,c,d - - other parameters: - fpa derivative of function at x=a - fpb derivative of function at x=b + + other parameters: + fpa derivative of function at x=a + fpb derivative of function at x=b */ double *dl, *dd, *du; @@ -684,12 +684,12 @@ void PairLocalDensity::parse_file(char *filename) { // broadcast number of LD potentials and number of (rho,frho) pairs if (me == 0) { - // first 2 comment lines ignored + // first 2 comment lines ignored utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); // extract number of potentials and number of (frho, rho) points - utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); + utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); sscanf(line, "%d %d", &nLD, &nrho); utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); } @@ -711,9 +711,9 @@ void PairLocalDensity::parse_file(char *filename) { memory->create(delta_rho, nLD,"pairLD:delta_rho"); memory->create(ftmp, nrho*nLD, "pairLD:ftmp"); - // setting up central and neighbor atom filters + // setting up central and neighbor atom filters memory->create(a, nLD, atom->ntypes+1 , "pairLD:a"); - memory->create(b, nLD, atom->ntypes+1, "pairLD:b"); + memory->create(b, nLD, atom->ntypes+1, "pairLD:b"); if (me == 0) { for (n = 1; n <= atom->ntypes; n++){ for (k = 0; k < nLD; k++) { @@ -721,14 +721,14 @@ void PairLocalDensity::parse_file(char *filename) { b[k][n] = 0; } } - } + } // read file block by block if (me == 0) { for (k = 0; k < nLD; k++) { - // parse upper and lower cut values + // parse upper and lower cut values if (fgets(line,MAXLINE,fptr)==NULL) break; sscanf(line, "%lf %lf", &lowercut[k], &uppercut[k]); @@ -743,7 +743,7 @@ void PairLocalDensity::parse_file(char *filename) { // parse neighbor atom filter utils::sfgets(FLERR,line, MAXLINE, fptr,filename,error); tmp = strtok(line, " /t/n/r/f"); - while (tmp != NULL) { + while (tmp != NULL) { b[k][atoi(tmp)] = 1; tmp = strtok(NULL, " /t/n/r/f"); } @@ -778,7 +778,7 @@ void PairLocalDensity::parse_file(char *filename) { } } - // Broadcast all parsed arrays + // Broadcast all parsed arrays MPI_Bcast(&lowercut[0], nLD, MPI_DOUBLE, 0, world); MPI_Bcast(&uppercut[0], nLD, MPI_DOUBLE, 0, world); MPI_Bcast(&lowercutsq[0], nLD, MPI_DOUBLE, 0, world); @@ -818,16 +818,16 @@ void PairLocalDensity::parse_file(char *filename) { ------------------------------------------------------------------------- */ int PairLocalDensity::pack_comm(int n, int *list, double *buf, - int /* pbc_flag */, int * /* pbc */) { + int /* pbc_flag */, int * /* pbc */) { int i,j,k; - int m; + int m; m = 0; for (i = 0; i < n; i++) { j = list[i]; for (k = 0; k < nLD; k++) { buf[m++] = fp[k][j]; - } + } } return nLD; @@ -845,7 +845,7 @@ void PairLocalDensity::unpack_comm(int n, int first, double *buf) { for (k = 0; k < nLD; k++) { fp[k][i] = buf[m++]; } - } + } } /* ---------------------------------------------------------------------- */ @@ -876,7 +876,7 @@ void PairLocalDensity::unpack_reverse_comm(int n, int *list, double *buf) { j = list[i]; for (k = 0; k < nLD; k++) { localrho[k][j] += buf[m++]; - } + } } } diff --git a/src/USER-MISC/pair_local_density.h b/src/USER-MISC/pair_local_density.h index 77aab1399b..5e37376ece 100644 --- a/src/USER-MISC/pair_local_density.h +++ b/src/USER-MISC/pair_local_density.h @@ -72,13 +72,13 @@ class PairLocalDensity : public Pair { void allocate(); - // read tabulated input file - void parse_file(char *); + // read tabulated input file + void parse_file(char *); - // convert array to spline - void array2spline(); - - // cubic spline interpolation + // convert array to spline + void array2spline(); + + // cubic spline interpolation void interpolate_cbspl(int, double, double *, double **); }; diff --git a/src/USER-OMP/reaxc_init_md_omp.cpp b/src/USER-OMP/reaxc_init_md_omp.cpp index fce23c645f..66f1acf91c 100644 --- a/src/USER-OMP/reaxc_init_md_omp.cpp +++ b/src/USER-OMP/reaxc_init_md_omp.cpp @@ -46,8 +46,8 @@ extern int Init_Workspace(reax_system*, control_params*, storage*, char*); /* ---------------------------------------------------------------------- */ int Init_ListsOMP(reax_system *system, control_params *control, - simulation_data * /* data */, storage * /* workspace */, - reax_list **lists, mpi_datatypes * /* mpi_data */, char * /* msg */) + simulation_data * /* data */, storage * /* workspace */, + reax_list **lists, mpi_datatypes * /* mpi_data */, char * /* msg */) { int i, total_hbonds, total_bonds, bond_cap, num_3body, cap_3body, Htop; int *hb_top, *bond_top; diff --git a/src/USER-REAXC/reaxc_ffield.cpp b/src/USER-REAXC/reaxc_ffield.cpp index e3a6645fc2..a44c7d5cbd 100644 --- a/src/USER-REAXC/reaxc_ffield.cpp +++ b/src/USER-REAXC/reaxc_ffield.cpp @@ -154,7 +154,7 @@ char Read_Force_Field( FILE *fp, reax_interaction *reax, /* Sanity checks */ if (c == 2 && !lgflag) - control->error_ptr->all(FLERR, "Force field file requires using 'lgvdw yes'"); + control->error_ptr->all(FLERR, "Force field file requires using 'lgvdw yes'"); if (c < 9) { snprintf (errmsg, 1024, "Missing parameter(s) in line %s", s); diff --git a/src/force.cpp b/src/force.cpp index cc121a5f80..63d1fcbe31 100644 --- a/src/force.cpp +++ b/src/force.cpp @@ -204,17 +204,17 @@ void Force::init() if (!bond && (atom->nbonds > 0)) { error->warning(FLERR,"Bonds are defined but no bond style is set"); if ((special_lj[1] != 1.0) || (special_coul[1] != 1.0)) - error->warning(FLERR,"Likewise 1-2 special neighbor interactions != 1.0"); + error->warning(FLERR,"Likewise 1-2 special neighbor interactions != 1.0"); } if (!angle && (atom->nangles > 0)) { error->warning(FLERR,"Angles are defined but no angle style is set"); if ((special_lj[2] != 1.0) || (special_coul[2] != 1.0)) - error->warning(FLERR,"Likewise 1-3 special neighbor interactions != 1.0"); + error->warning(FLERR,"Likewise 1-3 special neighbor interactions != 1.0"); } if (!dihedral && (atom->ndihedrals > 0)) { error->warning(FLERR,"Dihedrals are defined but no dihedral style is set"); if ((special_lj[3] != 1.0) || (special_coul[3] != 1.0)) - error->warning(FLERR,"Likewise 1-4 special neighbor interactions != 1.0"); + error->warning(FLERR,"Likewise 1-4 special neighbor interactions != 1.0"); } if (!improper && (atom->nimpropers > 0)) error->warning(FLERR,"Impropers are defined but no improper style is set"); diff --git a/src/min.h b/src/min.h index 61f9ce0bda..6f3e10d048 100644 --- a/src/min.h +++ b/src/min.h @@ -64,11 +64,11 @@ class Min : protected Pointers { int virial_style; // compute virial explicitly or implicitly int external_force_clear; // clear forces locally or externally - double dmax; // max dist to move any atom in one step - int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero - // 3 = spin_cubic, 4 = spin_none + double dmax; // max dist to move any atom in one step + int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero + // 3 = spin_cubic, 4 = spin_none - int normstyle; // TWO, MAX or INF flag for force norm evaluation + int normstyle; // TWO, MAX or INF flag for force norm evaluation int nelist_global,nelist_atom; // # of PE,virial computes to check int nvlist_global,nvlist_atom; diff --git a/src/min_cg.cpp b/src/min_cg.cpp index 80dde25f51..7b7046ea00 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -100,7 +100,7 @@ int MinCG::iterate(int maxiter) for (i = 0; i < n; i++) { dot[0] += fatom[i]*fatom[i]; dot[1] += fatom[i]*gatom[i]; - fmax = MAX(fmax,fatom[i]*fatom[i]); + fmax = MAX(fmax,fatom[i]*fatom[i]); } } MPI_Allreduce(dot,dotall,2,MPI_DOUBLE,MPI_SUM,world); @@ -111,13 +111,13 @@ int MinCG::iterate(int maxiter) } fmax = 0.0; - if (normstyle == MAX) { // max force norm + if (normstyle == MAX) { // max force norm fmax = fnorm_max(); if (fmax < update->ftol*update->ftol) return FTOL; - } else if (normstyle == INF) { // infinite force norm + } else if (normstyle == INF) { // infinite force norm fmax = fnorm_inf(); if (fmax < update->ftol*update->ftol) return FTOL; - } else if (normstyle == TWO) { // Euclidean force 2-norm + } else if (normstyle == TWO) { // Euclidean force 2-norm if (dotall[0] < update->ftol*update->ftol) return FTOL; } else error->all(FLERR,"Illegal min_modify command"); diff --git a/src/min_fire.cpp b/src/min_fire.cpp index b4b0f14534..3449f431c9 100644 --- a/src/min_fire.cpp +++ b/src/min_fire.cpp @@ -251,9 +251,9 @@ int MinFire::iterate(int maxiter) // sync across replicas if running multi-replica minimization if (update->ftol > 0.0) { - if (normstyle == MAX) fdotf = fnorm_max(); // max force norm - else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm - else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm else error->all(FLERR,"Illegal min_modify command"); if (update->multireplica == 0) { if (fdotf < update->ftol*update->ftol) return FTOL; diff --git a/src/min_sd.cpp b/src/min_sd.cpp index 627a3b3cf3..b89682ab5c 100644 --- a/src/min_sd.cpp +++ b/src/min_sd.cpp @@ -78,9 +78,9 @@ int MinSD::iterate(int maxiter) // force tolerance criterion - if (normstyle == MAX) fdotf = fnorm_max(); // max force norm - else if (normstyle == INF) fdotf = fnorm_inf(); // infinite force norm - else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // infinite force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm else error->all(FLERR,"Illegal min_modify command"); if (fdotf < update->ftol*update->ftol) return FTOL; From b6b022b6107eeb06edcb9c0937e8e4691526ae84 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Sun, 3 Nov 2019 11:03:39 -0500 Subject: [PATCH 334/557] whitespace cleanup: remove trailing blanks --- src/CLASS2/pair_lj_class2_coul_long.cpp | 20 +- src/CLASS2/pair_lj_class2_coul_long.h | 2 +- src/KOKKOS/comm_kokkos.cpp | 2 +- src/KOKKOS/domain_kokkos.cpp | 6 +- src/KOKKOS/kokkos.cpp | 2 +- src/KOKKOS/npair_kokkos.cpp | 2 +- src/KOKKOS/pair_kokkos.h | 4 +- src/KOKKOS/pair_snap_kokkos_impl.h | 16 +- src/KOKKOS/sna_kokkos.h | 2 +- src/KOKKOS/sna_kokkos_impl.h | 30 +-- src/KSPACE/ewald_dipole.cpp | 22 +- src/KSPACE/ewald_dipole_spin.cpp | 26 +- src/KSPACE/ewald_dipole_spin.h | 6 +- src/KSPACE/pppm_dipole.cpp | 16 +- src/KSPACE/pppm_dipole.h | 2 +- src/KSPACE/pppm_dipole_spin.cpp | 8 +- src/KSPACE/pppm_dipole_spin.h | 4 +- src/MANYBODY/pair_airebo.cpp | 8 +- src/RIGID/rigid_const.h | 2 +- src/SNAP/pair_snap.cpp | 4 +- src/SNAP/sna.cpp | 40 +-- src/SNAP/sna.h | 4 +- src/SPIN/atom_vec_spin.h | 2 +- src/SPIN/fix_nve_spin.cpp | 2 +- src/SPIN/fix_precession_spin.cpp | 10 +- src/SPIN/fix_precession_spin.h | 4 +- src/SPIN/fix_setforce_spin.cpp | 2 +- src/SPIN/fix_setforce_spin.h | 2 +- src/SPIN/min_spin_cg.cpp | 26 +- src/SPIN/min_spin_lbfgs.cpp | 16 +- src/SPIN/pair_spin.cpp | 2 +- src/SPIN/pair_spin_dipole_cut.cpp | 88 +++---- src/SPIN/pair_spin_dipole_cut.h | 12 +- src/SPIN/pair_spin_dipole_long.cpp | 86 +++---- src/SPIN/pair_spin_dipole_long.h | 12 +- src/USER-CGDNA/pair_oxdna2_excv.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 | 4 +- src/USER-MEAMC/meam_setup_done.cpp | 2 +- src/USER-MISC/compute_gyration_shape.cpp | 2 +- src/USER-MISC/compute_hma.cpp | 58 ++--- src/USER-MISC/compute_hma.h | 2 +- src/USER-MISC/pair_cosine_squared.cpp | 6 +- src/USER-MISC/pair_extep.cpp | 2 +- src/USER-MISC/pair_ilp_graphene_hbn.cpp | 4 +- src/USER-MISC/pair_kolmogorov_crespi_full.cpp | 6 +- src/USER-MISC/pair_local_density.cpp | 230 +++++++++--------- src/USER-MISC/pair_local_density.h | 22 +- src/USER-MOLFILE/reader_molfile.cpp | 2 +- src/USER-PHONON/dynamical_matrix.cpp | 2 +- src/USER-PLUMED/fix_plumed.cpp | 2 +- src/USER-REAXC/reaxc_ffield.cpp | 2 +- .../pair_lj_switch3_coulgauss_long.cpp | 6 +- .../pair_mm3_switch3_coulgauss_long.cpp | 6 +- src/comm.cpp | 2 +- src/compute_bond_local.cpp | 2 +- src/compute_orientorder_atom.cpp | 10 +- src/fix_neigh_history.cpp | 4 +- src/input.h | 2 +- src/lammps.cpp | 2 +- src/min.cpp | 2 +- src/min.h | 6 +- src/min_cg.cpp | 4 +- src/neighbor.cpp | 6 +- src/read_data.cpp | 2 +- src/read_dump.cpp | 2 +- src/reader_native.cpp | 2 +- 69 files changed, 452 insertions(+), 452 deletions(-) diff --git a/src/CLASS2/pair_lj_class2_coul_long.cpp b/src/CLASS2/pair_lj_class2_coul_long.cpp index c2b127fa58..1544232e49 100644 --- a/src/CLASS2/pair_lj_class2_coul_long.cpp +++ b/src/CLASS2/pair_lj_class2_coul_long.cpp @@ -664,19 +664,19 @@ void PairLJClass2CoulLong::init_style() if (!atom->q_flag) error->all(FLERR, "Pair style lj/class2/coul/long requires atom attribute q"); - + // request regular or rRESPA neighbor list - + int irequest; int respa = 0; - + if (update->whichflag == 1 && strstr(update->integrate_style,"respa")) { if (((Respa *) update->integrate)->level_inner >= 0) respa = 1; if (((Respa *) update->integrate)->level_middle >= 0) respa = 2; } - + irequest = neighbor->request(this,instance_me); - + if (respa >= 1) { neighbor->requests[irequest]->respaouter = 1; neighbor->requests[irequest]->respainner = 1; @@ -684,13 +684,13 @@ void PairLJClass2CoulLong::init_style() if (respa == 2) neighbor->requests[irequest]->respamiddle = 1; cut_coulsq = cut_coul * cut_coul; - + // set rRESPA cutoffs - + if (strstr(update->integrate_style,"respa") && ((Respa *) update->integrate)->level_inner >= 0) cut_respa = ((Respa *) update->integrate)->cutoff; - else cut_respa = NULL; + else cut_respa = NULL; // insure use of KSpace long-range solver, set g_ewald @@ -739,9 +739,9 @@ double PairLJClass2CoulLong::init_one(int i, int j) lj3[j][i] = lj3[i][j]; lj4[j][i] = lj4[i][j]; offset[j][i] = offset[i][j]; - + // check interior rRESPA cutoff - + if (cut_respa && MIN(cut_lj[i][j],cut_coul) < cut_respa[3]) error->all(FLERR,"Pair cutoff < Respa interior cutoff"); diff --git a/src/CLASS2/pair_lj_class2_coul_long.h b/src/CLASS2/pair_lj_class2_coul_long.h index 50d7092541..7b68382295 100644 --- a/src/CLASS2/pair_lj_class2_coul_long.h +++ b/src/CLASS2/pair_lj_class2_coul_long.h @@ -40,7 +40,7 @@ class PairLJClass2CoulLong : public Pair { void write_data(FILE *); void write_data_all(FILE *); double single(int, int, int, int, double, double, double, double &); - + void compute_inner(); void compute_middle(); void compute_outer(int, int); diff --git a/src/KOKKOS/comm_kokkos.cpp b/src/KOKKOS/comm_kokkos.cpp index d0bd978ae7..774d7040cc 100644 --- a/src/KOKKOS/comm_kokkos.cpp +++ b/src/KOKKOS/comm_kokkos.cpp @@ -210,7 +210,7 @@ void CommKokkos::forward_comm_device(int dummy) MPI_Send(k_buf_send.view().data(), n,MPI_DOUBLE,sendproc[iswap],0,world); } - + if (size_forward_recv[iswap]) { MPI_Wait(&request,MPI_STATUS_IGNORE); atomKK->modified(ExecutionSpaceFromDevice:: diff --git a/src/KOKKOS/domain_kokkos.cpp b/src/KOKKOS/domain_kokkos.cpp index 4cf3e6ab52..cb4eaddfec 100644 --- a/src/KOKKOS/domain_kokkos.cpp +++ b/src/KOKKOS/domain_kokkos.cpp @@ -340,11 +340,11 @@ struct DomainPBCFunctor { void DomainKokkos::pbc() { - + if (lmp->kokkos->exchange_comm_classic) { - + // reduce GPU data movement - + atomKK->sync(Host,X_MASK|V_MASK|MASK_MASK|IMAGE_MASK); Domain::pbc(); atomKK->modified(Host,X_MASK|V_MASK|MASK_MASK|IMAGE_MASK); diff --git a/src/KOKKOS/kokkos.cpp b/src/KOKKOS/kokkos.cpp index 18dff991b2..720dd3b3b2 100644 --- a/src/KOKKOS/kokkos.cpp +++ b/src/KOKKOS/kokkos.cpp @@ -187,7 +187,7 @@ KokkosLMP::KokkosLMP(LAMMPS *lmp, int narg, char **arg) : Pointers(lmp) binsize = 0.0; #ifdef KOKKOS_ENABLE_CUDA - cuda_aware_flag = 1; + cuda_aware_flag = 1; #else cuda_aware_flag = 0; #endif diff --git a/src/KOKKOS/npair_kokkos.cpp b/src/KOKKOS/npair_kokkos.cpp index 5470001967..dc0efbc193 100644 --- a/src/KOKKOS/npair_kokkos.cpp +++ b/src/KOKKOS/npair_kokkos.cpp @@ -101,7 +101,7 @@ void NPairKokkos::copy_stencil_info() // copy stencil to device as it may have changed int maxstencil = ns->get_maxstencil(); - + if (maxstencil > k_stencil.extent(0)) k_stencil = DAT::tdual_int_1d("neighlist:stencil",maxstencil); for (int k = 0; k < maxstencil; k++) diff --git a/src/KOKKOS/pair_kokkos.h b/src/KOKKOS/pair_kokkos.h index 9ca5d9578d..52a05b3991 100644 --- a/src/KOKKOS/pair_kokkos.h +++ b/src/KOKKOS/pair_kokkos.h @@ -293,7 +293,7 @@ struct PairComputeFunctor { const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if(rsq < (STACKPARAMS?c.m_cutsq[itype][jtype]:c.d_cutsq(itype,jtype))) { - + const F_FLOAT fpair = factor_lj*c.template compute_fpair(rsq,i,j,itype,jtype); ftmp.x += delx*fpair; @@ -412,7 +412,7 @@ struct PairComputeFunctor { const F_FLOAT rsq = delx*delx + dely*dely + delz*delz; if(rsq < (STACKPARAMS?c.m_cutsq[itype][jtype]:c.d_cutsq(itype,jtype))) { - + const F_FLOAT fpair = factor_lj*c.template compute_fpair(rsq,i,j,itype,jtype); fev_tmp.f[0] += delx*fpair; diff --git a/src/KOKKOS/pair_snap_kokkos_impl.h b/src/KOKKOS/pair_snap_kokkos_impl.h index 02c8554fa5..ef01ec5ea3 100644 --- a/src/KOKKOS/pair_snap_kokkos_impl.h +++ b/src/KOKKOS/pair_snap_kokkos_impl.h @@ -584,7 +584,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeDeidrj,const type 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); } @@ -619,9 +619,9 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeForce(ev,i,j, @@ -630,7 +630,7 @@ void PairSNAPKokkos::operator() (TagPairSNAPComputeForce::operator() (TagPairSNAPComputeForce::build_indexlist() 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_idxcg_block(j1,j2,j) = idxcg_count; + h_idxcg_block(j1,j2,j) = idxcg_count; for (int m1 = 0; m1 <= j1; m1++) for (int m2 = 0; m2 <= j2; m2++) idxcg_count++; @@ -98,9 +98,9 @@ void SNAKokkos::build_indexlist() 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; + h_idxu_block[j] = idxu_count; for(int mb = 0; mb <= j; mb++) for(int ma = 0; ma <= j; ma++) idxu_count++; @@ -110,16 +110,16 @@ void SNAKokkos::build_indexlist() // index list for beta and B - int idxb_count = 0; + 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++) @@ -142,7 +142,7 @@ void SNAKokkos::build_indexlist() for(int j2 = 0; j2 <= j1; j2++) for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { if (j >= j1) { - h_idxb_block(j1,j2,j) = idxb_count; + h_idxb_block(j1,j2,j) = idxb_count; idxb_count++; } } @@ -158,19 +158,19 @@ void SNAKokkos::build_indexlist() 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; + h_idxz_block(j1,j2,j) = idxz_count; // find right beta(ii,jjb) entry // multiply and divide by j+1 factors @@ -226,7 +226,7 @@ void SNAKokkos::grow_rij(int newnatom, int newnmax) blist = t_sna_2d("sna:blist",natom,idxb_max); ulisttot = t_sna_2c("sna:ulisttot",natom,idxu_max); - if (!Kokkos::Impl::is_same::value) + if (!Kokkos::Impl::is_same::value) ulisttot_lr = t_sna_2c_lr("sna:ulisttot_lr",natom,idxu_max); zlist = t_sna_2c("sna:zlist",natom,idxz_max); @@ -306,7 +306,7 @@ void SNAKokkos::compute_zi(const int& iter) const double* cgblock = cglist.data() + idxcg_block(j1,j2,j); - zlist(iatom,jjz).re = 0.0; + zlist(iatom,jjz).re = 0.0; zlist(iatom,jjz).im = 0.0; int jju1 = idxu_block[j1] + (j1+1)*mb1min; @@ -419,7 +419,7 @@ void SNAKokkos::compute_yi(int iter, if (j1 == j) { if (j2 == j) betaj = 3*beta(iatom,jjb); else betaj = 2*beta(iatom,jjb); - } else betaj = beta(iatom,jjb); + } else betaj = beta(iatom,jjb); } else if (j >= j2) { const int jjb = idxb_block(j,j2,j1); if (j2 == j) betaj = 2*beta(iatom,jjb)*(j1+1)/(j+1.0); @@ -1176,7 +1176,7 @@ void SNAKokkos::init_clebsch_gordan() factorial((j + cc2) / 2) * factorial((j - cc2) / 2) * (j + 1)); - + h_cglist[idxcg_count] = sum * dcg * sfaccg; idxcg_count++; } @@ -1278,7 +1278,7 @@ double SNAKokkos::memory_usage() if (!Kokkos::Impl::is_same::value) bytes += natom * idxu_max * sizeof(double) * 2; // ulisttot_lr 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 diff --git a/src/KSPACE/ewald_dipole.cpp b/src/KSPACE/ewald_dipole.cpp index a003ce91fd..1939742bfc 100644 --- a/src/KSPACE/ewald_dipole.cpp +++ b/src/KSPACE/ewald_dipole.cpp @@ -167,7 +167,7 @@ void EwaldDipole::init() NewtonSolve(g_ewald,cutoff,natoms,xprd*yprd*zprd,mu2); if (g_ewald_new > 0.0) g_ewald = g_ewald_new; else error->warning(FLERR,"Ewald/disp Newton solver failed, " - "using old method to estimate g_ewald"); + "using old method to estimate g_ewald"); } // setup EwaldDipole coefficients so can print stats @@ -246,7 +246,7 @@ void EwaldDipole::setup() double err; kxmax = 1; kymax = 1; - kzmax = 1; + kzmax = 1; // set kmax in 3 directions to respect accuracy @@ -462,7 +462,7 @@ void EwaldDipole::compute(int eflag, int vflag) vc[k][4] += vcik[4] = -(partial_peratom * mu[i][0] * eg[k][2]); vc[k][5] += vcik[5] = -(partial_peratom * mu[i][1] * eg[k][2]); - // taking re-part of struct_fact x exp(i*k*ri) + // taking re-part of struct_fact x exp(i*k*ri) // (for per-atom energy and virial calc.) if (evflag_atom) { @@ -653,12 +653,12 @@ void EwaldDipole::eik_dot_r() muz = mu[i][2]; // dir 1: (0,l,m) - mudotk = (muy*l*unitk[1] + muz*m*unitk[2]); + mudotk = (muy*l*unitk[1] + muz*m*unitk[2]); cstr1 += mudotk*(cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]); sstr1 += mudotk*(sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]); // dir 2: (0,l,-m) - mudotk = (muy*l*unitk[1] - muz*m*unitk[2]); + mudotk = (muy*l*unitk[1] - muz*m*unitk[2]); cstr2 += mudotk*(cs[l][1][i]*cs[m][2][i]+sn[l][1][i]*sn[m][2][i]); sstr2 += mudotk*(sn[l][1][i]*cs[m][2][i]-cs[l][1][i]*sn[m][2][i]); } @@ -685,12 +685,12 @@ void EwaldDipole::eik_dot_r() muz = mu[i][2]; // dir 1: (k,0,m) - mudotk = (mux*k*unitk[0] + muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] + muz*m*unitk[2]); cstr1 += mudotk*(cs[k][0][i]*cs[m][2][i]-sn[k][0][i]*sn[m][2][i]); sstr1 += mudotk*(sn[k][0][i]*cs[m][2][i]+cs[k][0][i]*sn[m][2][i]); // dir 2: (k,0,-m) - mudotk = (mux*k*unitk[0] - muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] - muz*m*unitk[2]); cstr2 += mudotk*(cs[k][0][i]*cs[m][2][i]+sn[k][0][i]*sn[m][2][i]); sstr2 += mudotk*(sn[k][0][i]*cs[m][2][i]-cs[k][0][i]*sn[m][2][i]); } @@ -724,28 +724,28 @@ void EwaldDipole::eik_dot_r() muz = mu[i][2]; // dir 1: (k,l,m) - mudotk = (mux*k*unitk[0] + muy*l*unitk[1] + muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] + muy*l*unitk[1] + muz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]; slpm = sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]; cstr1 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr1 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 2: (k,-l,m) - mudotk = (mux*k*unitk[0] - muy*l*unitk[1] + muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] - muy*l*unitk[1] + muz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] + sn[l][1][i]*sn[m][2][i]; slpm = -sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]; cstr2 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr2 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 3: (k,l,-m) - mudotk = (mux*k*unitk[0] + muy*l*unitk[1] - muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] + muy*l*unitk[1] - muz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] + sn[l][1][i]*sn[m][2][i]; slpm = sn[l][1][i]*cs[m][2][i] - cs[l][1][i]*sn[m][2][i]; cstr3 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr3 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 4: (k,-l,-m) - mudotk = (mux*k*unitk[0] - muy*l*unitk[1] - muz*m*unitk[2]); + mudotk = (mux*k*unitk[0] - muy*l*unitk[1] - muz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]; slpm = -sn[l][1][i]*cs[m][2][i] - cs[l][1][i]*sn[m][2][i]; cstr4 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); diff --git a/src/KSPACE/ewald_dipole_spin.cpp b/src/KSPACE/ewald_dipole_spin.cpp index 531f4cdec5..82832f6e4c 100644 --- a/src/KSPACE/ewald_dipole_spin.cpp +++ b/src/KSPACE/ewald_dipole_spin.cpp @@ -36,7 +36,7 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ -EwaldDipoleSpin::EwaldDipoleSpin(LAMMPS *lmp) : +EwaldDipoleSpin::EwaldDipoleSpin(LAMMPS *lmp) : EwaldDipole(lmp) { dipoleflag = 0; @@ -157,7 +157,7 @@ void EwaldDipoleSpin::init() NewtonSolve(g_ewald,cutoff,natoms,xprd*yprd*zprd,mu2); if (g_ewald_new > 0.0) g_ewald = g_ewald_new; else error->warning(FLERR,"Ewald/disp Newton solver failed, " - "using old method to estimate g_ewald"); + "using old method to estimate g_ewald"); } // setup EwaldDipoleSpin coefficients so can print stats @@ -236,7 +236,7 @@ void EwaldDipoleSpin::setup() double err; kxmax = 1; kymax = 1; - kzmax = 1; + kzmax = 1; // set kmax in 3 directions to respect accuracy @@ -440,7 +440,7 @@ void EwaldDipoleSpin::compute(int eflag, int vflag) vc[k][4] += vcik[4] = -(partial_peratom * spx * eg[k][2]); vc[k][5] += vcik[5] = -(partial_peratom * spy * eg[k][2]); - // taking re-part of struct_fact x exp(i*k*ri) + // taking re-part of struct_fact x exp(i*k*ri) // (for per-atom energy and virial calc.) if (evflag_atom) { @@ -639,12 +639,12 @@ void EwaldDipoleSpin::eik_dot_r() spz = sp[i][2]*sp[i][3]; // dir 1: (0,l,m) - mudotk = (spy*l*unitk[1] + spz*m*unitk[2]); + mudotk = (spy*l*unitk[1] + spz*m*unitk[2]); cstr1 += mudotk*(cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]); sstr1 += mudotk*(sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]); // dir 2: (0,l,-m) - mudotk = (spy*l*unitk[1] - spz*m*unitk[2]); + mudotk = (spy*l*unitk[1] - spz*m*unitk[2]); cstr2 += mudotk*(cs[l][1][i]*cs[m][2][i]+sn[l][1][i]*sn[m][2][i]); sstr2 += mudotk*(sn[l][1][i]*cs[m][2][i]-cs[l][1][i]*sn[m][2][i]); } @@ -671,12 +671,12 @@ void EwaldDipoleSpin::eik_dot_r() spz = sp[i][2]*sp[i][3]; // dir 1: (k,0,m) - mudotk = (spx*k*unitk[0] + spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] + spz*m*unitk[2]); cstr1 += mudotk*(cs[k][0][i]*cs[m][2][i]-sn[k][0][i]*sn[m][2][i]); sstr1 += mudotk*(sn[k][0][i]*cs[m][2][i]+cs[k][0][i]*sn[m][2][i]); // dir 2: (k,0,-m) - mudotk = (spx*k*unitk[0] - spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] - spz*m*unitk[2]); cstr2 += mudotk*(cs[k][0][i]*cs[m][2][i]+sn[k][0][i]*sn[m][2][i]); sstr2 += mudotk*(sn[k][0][i]*cs[m][2][i]-cs[k][0][i]*sn[m][2][i]); } @@ -710,28 +710,28 @@ void EwaldDipoleSpin::eik_dot_r() spz = sp[i][2]*sp[i][3]; // dir 1: (k,l,m) - mudotk = (spx*k*unitk[0] + spy*l*unitk[1] + spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] + spy*l*unitk[1] + spz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]; slpm = sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]; cstr1 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr1 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 2: (k,-l,m) - mudotk = (spx*k*unitk[0] - spy*l*unitk[1] + spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] - spy*l*unitk[1] + spz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] + sn[l][1][i]*sn[m][2][i]; slpm = -sn[l][1][i]*cs[m][2][i] + cs[l][1][i]*sn[m][2][i]; cstr2 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr2 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 3: (k,l,-m) - mudotk = (spx*k*unitk[0] + spy*l*unitk[1] - spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] + spy*l*unitk[1] - spz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] + sn[l][1][i]*sn[m][2][i]; slpm = sn[l][1][i]*cs[m][2][i] - cs[l][1][i]*sn[m][2][i]; cstr3 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); sstr3 += mudotk*(sn[k][0][i]*clpm + cs[k][0][i]*slpm); // dir 4: (k,-l,-m) - mudotk = (spx*k*unitk[0] - spy*l*unitk[1] - spz*m*unitk[2]); + mudotk = (spx*k*unitk[0] - spy*l*unitk[1] - spz*m*unitk[2]); clpm = cs[l][1][i]*cs[m][2][i] - sn[l][1][i]*sn[m][2][i]; slpm = -sn[l][1][i]*cs[m][2][i] - cs[l][1][i]*sn[m][2][i]; cstr4 += mudotk*(cs[k][0][i]*clpm - sn[k][0][i]*slpm); @@ -768,7 +768,7 @@ void EwaldDipoleSpin::slabcorr() double spz; int nlocal = atom->nlocal; - for (int i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { spz = sp[i][2]*sp[i][3]; spin += spz; } diff --git a/src/KSPACE/ewald_dipole_spin.h b/src/KSPACE/ewald_dipole_spin.h index 20852c08c1..32c7ddb5f1 100644 --- a/src/KSPACE/ewald_dipole_spin.h +++ b/src/KSPACE/ewald_dipole_spin.h @@ -33,13 +33,13 @@ class EwaldDipoleSpin : public EwaldDipole { void compute(int, int); protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton double mu_0; // vacuum permeability double mub2mu0; // prefactor for mech force double mub2mu0hbinv; // prefactor for mag force - void spsum_musq(); + void spsum_musq(); virtual void eik_dot_r(); void slabcorr(); diff --git a/src/KSPACE/pppm_dipole.cpp b/src/KSPACE/pppm_dipole.cpp index 5d69ca27b6..40d0c1ac73 100644 --- a/src/KSPACE/pppm_dipole.cpp +++ b/src/KSPACE/pppm_dipole.cpp @@ -58,19 +58,19 @@ enum{FORWARD_MU,FORWARD_MU_PERATOM}; /* ---------------------------------------------------------------------- */ PPPMDipole::PPPMDipole(LAMMPS *lmp) : PPPM(lmp), - densityx_brick_dipole(NULL), densityy_brick_dipole(NULL), + densityx_brick_dipole(NULL), densityy_brick_dipole(NULL), densityz_brick_dipole(NULL), vdxx_brick_dipole(NULL), vdyy_brick_dipole(NULL), vdzz_brick_dipole(NULL), vdxy_brick_dipole(NULL), vdxz_brick_dipole(NULL), vdyz_brick_dipole(NULL), ux_brick_dipole(NULL), uy_brick_dipole(NULL), uz_brick_dipole(NULL), v0x_brick_dipole(NULL), v1x_brick_dipole(NULL), - v2x_brick_dipole(NULL), v3x_brick_dipole(NULL), v4x_brick_dipole(NULL), - v5x_brick_dipole(NULL), v0y_brick_dipole(NULL), v1y_brick_dipole(NULL), - v2y_brick_dipole(NULL), v3y_brick_dipole(NULL), v4y_brick_dipole(NULL), - v5y_brick_dipole(NULL), v0z_brick_dipole(NULL), v1z_brick_dipole(NULL), - v2z_brick_dipole(NULL), v3z_brick_dipole(NULL), v4z_brick_dipole(NULL), - v5z_brick_dipole(NULL), work3(NULL), work4(NULL), - densityx_fft_dipole(NULL), densityy_fft_dipole(NULL), + v2x_brick_dipole(NULL), v3x_brick_dipole(NULL), v4x_brick_dipole(NULL), + v5x_brick_dipole(NULL), v0y_brick_dipole(NULL), v1y_brick_dipole(NULL), + v2y_brick_dipole(NULL), v3y_brick_dipole(NULL), v4y_brick_dipole(NULL), + v5y_brick_dipole(NULL), v0z_brick_dipole(NULL), v1z_brick_dipole(NULL), + v2z_brick_dipole(NULL), v3z_brick_dipole(NULL), v4z_brick_dipole(NULL), + v5z_brick_dipole(NULL), work3(NULL), work4(NULL), + densityx_fft_dipole(NULL), densityy_fft_dipole(NULL), densityz_fft_dipole(NULL) { dipoleflag = 1; diff --git a/src/KSPACE/pppm_dipole.h b/src/KSPACE/pppm_dipole.h index d06919644b..a767f8b4c2 100644 --- a/src/KSPACE/pppm_dipole.h +++ b/src/KSPACE/pppm_dipole.h @@ -38,7 +38,7 @@ class PPPMDipole : public PPPM { protected: void set_grid_global(); - double newton_raphson_f(); + double newton_raphson_f(); void allocate(); void allocate_peratom(); diff --git a/src/KSPACE/pppm_dipole_spin.cpp b/src/KSPACE/pppm_dipole_spin.cpp index 38757ced21..7f7745eb3e 100644 --- a/src/KSPACE/pppm_dipole_spin.cpp +++ b/src/KSPACE/pppm_dipole_spin.cpp @@ -52,7 +52,7 @@ enum{FORWARD_MU,FORWARD_MU_PERATOM}; /* ---------------------------------------------------------------------- */ -PPPMDipoleSpin::PPPMDipoleSpin(LAMMPS *lmp) : +PPPMDipoleSpin::PPPMDipoleSpin(LAMMPS *lmp) : PPPMDipole(lmp) { dipoleflag = 0; @@ -147,7 +147,7 @@ void PPPMDipoleSpin::init() // kspace TIP4P not yet supported // qdist = offset only for TIP4P fictitious charge - qdist = 0.0; + qdist = 0.0; if (tip4pflag) error->all(FLERR,"Cannot yet use TIP4P with PPPMDipoleSpin"); @@ -668,7 +668,7 @@ void PPPMDipoleSpin::slabcorr() double spz; int nlocal = atom->nlocal; - for (int i = 0; i < nlocal; i++) { + for (int i = 0; i < nlocal; i++) { spz = sp[i][2]*sp[i][3]; spin += spz; } @@ -729,7 +729,7 @@ void PPPMDipoleSpin::spsum_spsq() spsqsum_local += spx*spx + spy*spy + spz*spz; } - // store results into pppm_dipole quantities + // store results into pppm_dipole quantities MPI_Allreduce(&spsum_local,&musum,1,MPI_DOUBLE,MPI_SUM,world); MPI_Allreduce(&spsqsum_local,&musqsum,1,MPI_DOUBLE,MPI_SUM,world); diff --git a/src/KSPACE/pppm_dipole_spin.h b/src/KSPACE/pppm_dipole_spin.h index 2b4a989d5c..fe88fc75ce 100644 --- a/src/KSPACE/pppm_dipole_spin.h +++ b/src/KSPACE/pppm_dipole_spin.h @@ -32,8 +32,8 @@ class PPPMDipoleSpin : public PPPMDipole { void compute(int, int); protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton double mu_0; // vacuum permeability double mub2mu0; // prefactor for mech force double mub2mu0hbinv; // prefactor for mag force diff --git a/src/MANYBODY/pair_airebo.cpp b/src/MANYBODY/pair_airebo.cpp index 7cdffa7ea9..1d9dd18887 100644 --- a/src/MANYBODY/pair_airebo.cpp +++ b/src/MANYBODY/pair_airebo.cpp @@ -3638,9 +3638,9 @@ void PairAIREBO::read_file(char *filename) utils::sfgets(FLERR,s,MAXLINE,fp,filename,error); if (1 != sscanf(s,"%lg",&reqM_HH)) ++cerror; } - + } - + // check for errors parsing global parameters MPI_Bcast(&cerror,1,MPI_INT,0,world); @@ -3654,7 +3654,7 @@ void PairAIREBO::read_file(char *filename) cerror = numpar = 0; if (me == 0) { - + // gC spline utils::sfgets(FLERR,s,MAXLINE,fp,filename,error); @@ -3899,7 +3899,7 @@ void PairAIREBO::read_file(char *filename) fclose(fp); } - + // check for errors parsing spline data MPI_Bcast(&cerror,1,MPI_INT,0,world); diff --git a/src/RIGID/rigid_const.h b/src/RIGID/rigid_const.h index 14db517fcd..3aae988197 100644 --- a/src/RIGID/rigid_const.h +++ b/src/RIGID/rigid_const.h @@ -32,7 +32,7 @@ namespace LAMMPS_NS { ANGMOM = 1<<7, TORQUE = 1<<8 }; - + static const double TOLERANCE = 1.0e-6; static const double EPSILON = 1.0e-7; static const double BIG = 1.0e20; diff --git a/src/SNAP/pair_snap.cpp b/src/SNAP/pair_snap.cpp index 133f0e414b..6f7cf54659 100644 --- a/src/SNAP/pair_snap.cpp +++ b/src/SNAP/pair_snap.cpp @@ -108,7 +108,7 @@ void PairSNAP::compute(int eflag, int vflag) // compute dE_i/dB_i = beta_i for all i in list - if (quadraticflag || eflag) + if (quadraticflag || eflag) compute_bispectrum(); compute_beta(); @@ -165,7 +165,7 @@ void PairSNAP::compute(int eflag, int vflag) snaptr->compute_ui(ninside); // for neighbors of I within cutoff: - // compute Fij = dEi/dRj = -dEi/dRi + // compute Fij = dEi/dRj = -dEi/dRi // add to Fi, subtract from Fj snaptr->compute_yi(beta[ii]); diff --git a/src/SNAP/sna.cpp b/src/SNAP/sna.cpp index 9e8768c477..99834635b7 100644 --- a/src/SNAP/sna.cpp +++ b/src/SNAP/sna.cpp @@ -171,7 +171,7 @@ void SNA::build_indexlist() 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) { - idxcg_block[j1][j2][j] = idxcg_count; + idxcg_block[j1][j2][j] = idxcg_count; for (int m1 = 0; m1 <= j1; m1++) for (int m2 = 0; m2 <= j2; m2++) idxcg_count++; @@ -185,9 +185,9 @@ void SNA::build_indexlist() "sna:idxu_block"); int idxu_count = 0; - + for(int j = 0; j <= twojmax; j++) { - idxu_block[j] = idxu_count; + idxu_block[j] = idxu_count; for(int mb = 0; mb <= j; mb++) for(int ma = 0; ma <= j; ma++) idxu_count++; @@ -196,15 +196,15 @@ void SNA::build_indexlist() // index list for beta and B - int idxb_count = 0; + 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 = new SNA_BINDICES[idxb_max]; - + idxb_count = 0; for(int j1 = 0; j1 <= twojmax; j1++) for(int j2 = 0; j2 <= j1; j2++) @@ -225,7 +225,7 @@ void SNA::build_indexlist() for(int j2 = 0; j2 <= j1; j2++) for(int j = j1 - j2; j <= MIN(twojmax, j1 + j2); j += 2) { if (j >= j1) { - idxb_block[j1][j2][j] = idxb_count; + idxb_block[j1][j2][j] = idxb_count; idxb_count++; } } @@ -240,18 +240,18 @@ void SNA::build_indexlist() for (int mb = 0; 2*mb <= j; mb++) for (int ma = 0; ma <= j; ma++) idxz_count++; - + idxz_max = idxz_count; idxz = new SNA_ZINDICES[idxz_max]; - + memory->create(idxz_block, jdim, jdim, jdim, "sna: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) { - idxz_block[j1][j2][j] = idxz_count; + idxz_block[j1][j2][j] = idxz_count; // find right beta[jjb] entry // multiply and divide by j+1 factors @@ -481,7 +481,7 @@ void SNA::compute_yi(const double* beta) if (j1 == j) { if (j2 == j) betaj = 3*beta[jjb]; else betaj = 2*beta[jjb]; - } else betaj = beta[jjb]; + } else betaj = beta[jjb]; } else if (j >= j2) { const int jjb = idxb_block[j][j2][j1]; if (j2 == j) betaj = 2*beta[jjb]*(j1+1)/(j+1.0); @@ -549,7 +549,7 @@ void SNA::compute_deidrj(double* dedr) double jjjmambyarray_i = ylist_i[jju]; for(int k = 0; k < 3; k++) - dedr[k] += + dedr[k] += (dudr_r[k] * jjjmambyarray_r + dudr_i[k] * jjjmambyarray_i)*0.5; jju++; @@ -588,24 +588,24 @@ void SNA::compute_bi() double sumzu = 0.0; for (int mb = 0; 2*mb < j; mb++) for (int ma = 0; ma <= j; ma++) { - sumzu += ulisttot_r[jju]*zlist_r[jjz] + + sumzu += ulisttot_r[jju]*zlist_r[jjz] + ulisttot_i[jju]*zlist_i[jjz]; jjz++; jju++; - } // end loop over ma, mb + } // 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++) { - sumzu += ulisttot_r[jju]*zlist_r[jjz] + + sumzu += ulisttot_r[jju]*zlist_r[jjz] + ulisttot_i[jju]*zlist_i[jjz]; jjz++; jju++; } - sumzu += 0.5*(ulisttot_r[jju]*zlist_r[jjz] + + sumzu += 0.5*(ulisttot_r[jju]*zlist_r[jjz] + ulisttot_i[jju]*zlist_i[jjz]); } // end if jeven @@ -1485,7 +1485,7 @@ void SNA::init_clebsch_gordan() factorial((j - j2 + aa2) / 2 + z) * factorial((j - j1 - bb2) / 2 + z)); } - + cc2 = 2 * m - j; dcg = deltacg(j1, j2, j); sfaccg = sqrt(factorial((j1 + aa2) / 2) * @@ -1495,7 +1495,7 @@ void SNA::init_clebsch_gordan() factorial((j + cc2) / 2) * factorial((j - cc2) / 2) * (j + 1)); - + cglist[idxcg_count] = sum * dcg * sfaccg; idxcg_count++; } @@ -1519,7 +1519,7 @@ void SNA::print_clebsch_gordan() for (int j1 = 0; j1 <= twojmax; j1++) for (int j2 = 0; j2 <= j1; j2++) if (j1-j2 <= j && j1+j2 >= j && (j1+j2+j)%2 == 0) { - int idxcg_count = idxcg_block[j1][j2][j]; + int idxcg_count = idxcg_block[j1][j2][j]; for (int m1 = 0; m1 <= j1; m1++) { aa2 = 2*m1-j1; for (int m2 = 0; m2 <= j2; m2++) { diff --git a/src/SNAP/sna.h b/src/SNAP/sna.h index 5ea65fd84b..16d3338277 100644 --- a/src/SNAP/sna.h +++ b/src/SNAP/sna.h @@ -81,8 +81,8 @@ private: int idxcg_max, idxu_max, idxz_max, idxb_max; double** rootpqarray; - double* cglist; - int*** idxcg_block; + double* cglist; + int*** idxcg_block; double* ulisttot_r, * ulisttot_i; double** ulist_r_ij, ** ulist_i_ij; diff --git a/src/SPIN/atom_vec_spin.h b/src/SPIN/atom_vec_spin.h index a31e57bb48..6ce2c9dc7d 100644 --- a/src/SPIN/atom_vec_spin.h +++ b/src/SPIN/atom_vec_spin.h @@ -68,7 +68,7 @@ class AtomVecSpin : public AtomVec { int *type,*mask; imageint *image; double **x,**v,**f; // lattice quantities - + // spin quantities double **sp; // sp[i][0-2] direction of the spin i // sp[i][3] atomic magnetic moment of the spin i diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index 87546ba9da..462a359d99 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -247,7 +247,7 @@ void FixNVESpin::init() locksetforcespin = (FixSetForceSpin *) modify->fix[iforce]; } } - + // setting the sector variables/lists nsectors = 0; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 97dbe7ba6f..e1f24e36c2 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -126,7 +126,7 @@ FixPrecessionSpin::FixPrecessionSpin(LAMMPS *lmp, int narg, char **arg) : Fix(lm nay *= inorm; naz *= inorm; } - + if (cubic_flag) { inorm = 1.0/sqrt(nc1x*nc1x + nc1y*nc1y + nc1z*nc1z); nc1x *= inorm; @@ -244,7 +244,7 @@ void FixPrecessionSpin::post_force(int /* vflag */) double **sp = atom->sp; const int nlocal = atom->nlocal; double spi[3], fmi[3], epreci; - + eflag = 0; eprec = 0.0; for (int i = 0; i < nlocal; i++) { @@ -317,7 +317,7 @@ double FixPrecessionSpin::compute_anisotropy_energy(double spi[3]) double energy = 0.0; double scalar = nax*spi[0] + nay*spi[1] + naz*spi[2]; energy = Ka*scalar*scalar; - return energy; + return energy; } /* ---------------------------------------------------------------------- */ @@ -391,11 +391,11 @@ void FixPrecessionSpin::compute_cubic(double spi[3], double fmi[3]) six1 = 2.0*skx*sky2*skz2; six2 = 2.0*sky*skx2*skz2; six3 = 2.0*skz*skx2*sky2; - + sixx = k2ch*(nc1x*six1 + nc2x*six2 + nc3x*six3); sixy = k2ch*(nc1y*six1 + nc2y*six2 + nc3y*six3); sixz = k2ch*(nc1z*six1 + nc2z*six2 + nc3z*six3); - + fmi[0] += fourx + sixx; fmi[1] += foury + sixy; fmi[2] += fourz + sixz; diff --git a/src/SPIN/fix_precession_spin.h b/src/SPIN/fix_precession_spin.h index 96d89e004e..6ece653ca7 100644 --- a/src/SPIN/fix_precession_spin.h +++ b/src/SPIN/fix_precession_spin.h @@ -42,7 +42,7 @@ class FixPrecessionSpin : public Fix { int zeeman_flag, aniso_flag, cubic_flag; void compute_single_precession(int, double *, double *); void compute_zeeman(int, double *); - + // uniaxial aniso calculations void compute_anisotropy(double *, double *); @@ -52,7 +52,7 @@ class FixPrecessionSpin : public Fix { void compute_cubic(double *, double *); double compute_cubic_energy(double *); - + protected: int style; // style of the magnetic precession diff --git a/src/SPIN/fix_setforce_spin.cpp b/src/SPIN/fix_setforce_spin.cpp index e36a9d260d..ec738b7522 100644 --- a/src/SPIN/fix_setforce_spin.cpp +++ b/src/SPIN/fix_setforce_spin.cpp @@ -140,7 +140,7 @@ void FixSetForceSpin::single_setforce_spin(int i, double fmi[3]) foriginal[0] = foriginal[1] = foriginal[2] = 0.0; force_flag = 0; - + // constant force if (varflag == CONSTANT) { diff --git a/src/SPIN/fix_setforce_spin.h b/src/SPIN/fix_setforce_spin.h index a836911d85..1c5ce54dd3 100644 --- a/src/SPIN/fix_setforce_spin.h +++ b/src/SPIN/fix_setforce_spin.h @@ -29,7 +29,7 @@ class FixSetForceSpin : public FixSetForce { FixSetForceSpin(class LAMMPS *, int, char **); virtual void post_force(int); void post_force_respa(int, int, int); - void single_setforce_spin(int, double *); + void single_setforce_spin(int, double *); }; } diff --git a/src/SPIN/min_spin_cg.cpp b/src/SPIN/min_spin_cg.cpp index 9c8c814bc4..8815ad89db 100644 --- a/src/SPIN/min_spin_cg.cpp +++ b/src/SPIN/min_spin_cg.cpp @@ -16,8 +16,8 @@ Julien Tranchida (SNL) Please cite the related publication: - Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust - Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv preprint arXiv:1904.02669. ------------------------------------------------------------------------- */ @@ -105,7 +105,7 @@ void MinSpinCG::init() error->warning(FLERR,"Line search incompatible gneb"); // set back use_line_search to 0 if more than one replica - + if (linestyle == 3 && nreplica == 1){ use_line_search = 1; } @@ -201,10 +201,10 @@ int MinSpinCG::iterate(int maxiter) if (timer->check_timeout(niter)) return TIMEOUT; - + ntimestep = ++update->ntimestep; niter++; - + // optimize timestep accross processes / replicas // need a force calculation for timestep optimization @@ -249,7 +249,7 @@ int MinSpinCG::iterate(int maxiter) // energy tolerance criterion // only check after DELAYSTEP elapsed since velocties reset to 0 // sync across replicas if running multi-replica minimization - + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { if (update->multireplica == 0) { if (fabs(ecurrent-eprevious) < @@ -365,7 +365,7 @@ void MinSpinCG::calc_search_direction() MPI_Allreduce(&g2old,&g2old_global,1,MPI_DOUBLE,MPI_SUM,world); // Sum over all replicas. Good for GNEB. - + if (nreplica > 1) { g2 = g2_global * factor; g2old = g2old_global * factor; @@ -374,9 +374,9 @@ void MinSpinCG::calc_search_direction() } if (fabs(g2_global) < 1.0e-60) beta = 0.0; else beta = g2_global / g2old_global; - + // calculate conjugate direction - + for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = (beta * p_s[i] - g_cur[i]) * factor; g_old[i] = g_cur[i] * factor; @@ -401,9 +401,9 @@ void MinSpinCG::advance_spins() for (int i = 0; i < nlocal; i++) { rodrigues_rotation(p_s + 3 * i, rot_mat); - + // rotate spins - + vm3(rot_mat, sp[i], s_new); for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; } @@ -414,7 +414,7 @@ void MinSpinCG::advance_spins() (R. Murray, Z. Li, and S. Shankar Sastry, A Mathematical Introduction to Robotic Manipulation (1994), p. 28 and 30). - + upp_tr - vector x, y, z so that one calculate U = exp(A) with A= [[0, x, y], [-x, 0, z], @@ -431,7 +431,7 @@ void MinSpinCG::rodrigues_rotation(const double *upp_tr, double *out) fabs(upp_tr[2]) < 1.0e-40){ // if upp_tr is zero, return unity matrix - + for(int k = 0; k < 3; k++){ for(int m = 0; m < 3; m++){ if (m == k) out[3 * k + m] = 1.0; diff --git a/src/SPIN/min_spin_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp index a1ee010f3f..7f6d7692cd 100644 --- a/src/SPIN/min_spin_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -16,8 +16,8 @@ Julien Tranchida (SNL) Please cite the related publication: - Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust - Algorithm for the Minimisation of the Energy of Spin Systems. arXiv + Ivanov, A. V., Uzdin, V. M., & Jónsson, H. (2019). Fast and Robust + Algorithm for the Minimisation of the Energy of Spin Systems. arXiv preprint arXiv:1904.02669. ------------------------------------------------------------------------- */ @@ -213,10 +213,10 @@ int MinSpinLBFGS::iterate(int maxiter) if (timer->check_timeout(niter)) return TIMEOUT; - + ntimestep = ++update->ntimestep; niter++; - + // optimize timestep accross processes / replicas // need a force calculation for timestep optimization @@ -264,7 +264,7 @@ int MinSpinLBFGS::iterate(int maxiter) // energy tolerance criterion // only check after DELAYSTEP elapsed since velocties reset to 0 // sync across replicas if running multi-replica minimization - + if (update->etol > 0.0 && ntimestep-last_negative > DELAYSTEP) { if (update->multireplica == 0) { if (fabs(ecurrent-eprevious) < @@ -526,9 +526,9 @@ void MinSpinLBFGS::advance_spins() for (int i = 0; i < nlocal; i++) { rodrigues_rotation(p_s + 3 * i, rot_mat); - + // rotate spins - + vm3(rot_mat, sp[i], s_new); for (int j = 0; j < 3; j++) sp[i][j] = s_new[j]; } @@ -539,7 +539,7 @@ void MinSpinLBFGS::advance_spins() (R. Murray, Z. Li, and S. Shankar Sastry, A Mathematical Introduction to Robotic Manipulation (1994), p. 28 and 30). - + upp_tr - vector x, y, z so that one calculate U = exp(A) with A= [[0, x, y], [-x, 0, z], diff --git a/src/SPIN/pair_spin.cpp b/src/SPIN/pair_spin.cpp index d956729e60..f167e3455c 100644 --- a/src/SPIN/pair_spin.cpp +++ b/src/SPIN/pair_spin.cpp @@ -82,7 +82,7 @@ void PairSpin::init_style() bool have_fix = ((modify->find_fix_by_style("^nve/spin") != -1) || (modify->find_fix_by_style("^neb/spin") != -1)); - + if (!have_fix && (comm->me == 0)) error->warning(FLERR,"Using spin pair style without nve/spin or neb/spin"); diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index bae09689de..a393fe7021 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -76,9 +76,9 @@ void PairSpinDipoleCut::settings(int narg, char **arg) PairSpin::settings(narg,arg); cut_spin_long_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++) { @@ -99,10 +99,10 @@ void PairSpinDipoleCut::settings(int narg, char **arg) void PairSpinDipoleCut::coeff(int narg, char **arg) { if (!allocated) allocate(); - - if (narg != 3) + + if (narg != 3) error->all(FLERR,"Incorrect args in pair_style command"); - + int ilo,ihi,jlo,jhi; force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); @@ -128,9 +128,9 @@ void PairSpinDipoleCut::coeff(int narg, char **arg) double PairSpinDipoleCut::init_one(int i, int j) { if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - + cut_spin_long[j][i] = cut_spin_long[i][j]; - + return cut_spin_long_global; } @@ -163,8 +163,8 @@ void *PairSpinDipoleCut::extract(const char *str, int &dim) void PairSpinDipoleCut::compute(int eflag, int vflag) { - int i,j,ii,jj,inum,jnum,itype,jtype; - int *ilist,*jlist,*numneigh,**firstneigh; + int i,j,ii,jj,inum,jnum,itype,jtype; + int *ilist,*jlist,*numneigh,**firstneigh; double rinv,r2inv,r3inv,rsq,local_cut2,evdwl,ecoul; double xi[3],rij[3],eij[3],spi[4],spj[4],fi[3],fmi[3]; @@ -172,13 +172,13 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) if (eflag || vflag) ev_setup(eflag,vflag); else evflag = vflag_fdotr = 0; - int *type = atom->type; - int nlocal = atom->nlocal; + int *type = atom->type; + int nlocal = atom->nlocal; int newton_pair = force->newton_pair; double **x = atom->x; double **f = atom->f; double **fm = atom->fm; - double **sp = atom->sp; + double **sp = atom->sp; inum = list->inum; ilist = list->ilist; @@ -194,9 +194,9 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) xi[1] = x[i][1]; xi[2] = x[i][2]; jlist = firstneigh[i]; - jnum = numneigh[i]; - spi[0] = sp[i][0]; - spi[1] = sp[i][1]; + jnum = numneigh[i]; + spi[0] = sp[i][0]; + spi[1] = sp[i][1]; spi[2] = sp[i][2]; spi[3] = sp[i][3]; itype = type[i]; @@ -206,15 +206,15 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) j &= NEIGHMASK; jtype = type[j]; - spj[0] = sp[j][0]; - spj[1] = sp[j][1]; - spj[2] = sp[j][2]; - spj[3] = sp[j][3]; + spj[0] = sp[j][0]; + spj[1] = sp[j][1]; + spj[2] = sp[j][2]; + spj[3] = sp[j][3]; evdwl = 0.0; fi[0] = fi[1] = fi[2] = 0.0; fmi[0] = fmi[1] = fmi[2] = 0.0; - + rij[0] = x[j][0] - xi[0]; rij[1] = x[j][1] - xi[1]; rij[2] = x[j][2] - xi[2]; @@ -229,23 +229,23 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) if (rsq < local_cut2) { r2inv = 1.0/rsq; r3inv = r2inv*rinv; - + compute_dipolar(i,j,eij,fmi,spi,spj,r3inv); if (lattice_flag) compute_dipolar_mech(i,j,eij,fi,spi,spj,r2inv); } // 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][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]; } @@ -269,21 +269,21 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) { - int j,jnum,itype,jtype,ntypes; - int *jlist,*numneigh,**firstneigh; + int j,jnum,itype,jtype,ntypes; + int *jlist,*numneigh,**firstneigh; double rsq,rinv,r2inv,r3inv,local_cut2; double xi[3],rij[3],eij[3],spi[4],spj[4]; int k,locflag; - int *type = atom->type; + int *type = atom->type; double **x = atom->x; - double **sp = atom->sp; + double **sp = atom->sp; numneigh = list->numneigh; firstneigh = list->firstneigh; // check if interaction applies to type of ii - + itype = type[ii]; ntypes = atom->ntypes; locflag = 0; @@ -307,28 +307,28 @@ void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) // if interaction applies to type ii, // locflag = 1 and compute pair interaction - + if (locflag == 1) { xi[0] = x[ii][0]; xi[1] = x[ii][1]; xi[2] = x[ii][2]; - spi[0] = sp[ii][0]; - spi[1] = sp[ii][1]; + spi[0] = sp[ii][0]; + spi[1] = sp[ii][1]; spi[2] = sp[ii][2]; spi[3] = sp[ii][3]; jlist = firstneigh[ii]; - jnum = numneigh[ii]; - + jnum = numneigh[ii]; + for (int jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; jtype = type[j]; - spj[0] = sp[j][0]; - spj[1] = sp[j][1]; - spj[2] = sp[j][2]; - spj[3] = sp[j][3]; + spj[0] = sp[j][0]; + spj[1] = sp[j][1]; + spj[2] = sp[j][2]; + spj[3] = sp[j][3]; rij[0] = x[j][0] - xi[0]; rij[1] = x[j][1] - xi[1]; @@ -344,9 +344,9 @@ void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) if (rsq < local_cut2) { r2inv = 1.0/rsq; r3inv = r2inv*rinv; - + // compute dipolar interaction - + compute_dipolar(ii,j,eij,fmi,spi,spj,r3inv); } } @@ -357,7 +357,7 @@ void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) compute dipolar interaction between spins i and j ------------------------------------------------------------------------- */ -void PairSpinDipoleCut::compute_dipolar(int /* i */, int /* j */, double eij[3], +void PairSpinDipoleCut::compute_dipolar(int /* i */, int /* j */, double eij[3], double fmi[3], double spi[4], double spj[4], double r3inv) { double sjdotr; @@ -373,7 +373,7 @@ void PairSpinDipoleCut::compute_dipolar(int /* i */, int /* j */, double eij[3], } /* ---------------------------------------------------------------------- - compute the mechanical force due to the dipolar interaction between + compute the mechanical force due to the dipolar interaction between atom i and atom j ------------------------------------------------------------------------- */ @@ -387,7 +387,7 @@ void PairSpinDipoleCut::compute_dipolar_mech(int /* i */, int /* j */, double ei sisj = spi[0]*spj[0] + spi[1]*spj[1] + spi[2]*spj[2]; sieij = spi[0]*eij[0] + spi[1]*eij[1] + spi[2]*eij[2]; sjeij = spj[0]*eij[0] + spj[1]*eij[1] + spj[2]*eij[2]; - + bij = sisj - 5.0*sieij*sjeij; pre = 3.0*mub2mu0*gigjri4; diff --git a/src/SPIN/pair_spin_dipole_cut.h b/src/SPIN/pair_spin_dipole_cut.h index 33f62d1633..3adceaf1c7 100644 --- a/src/SPIN/pair_spin_dipole_cut.h +++ b/src/SPIN/pair_spin_dipole_cut.h @@ -34,22 +34,22 @@ class PairSpinDipoleCut : public PairSpin { void settings(int, char **); void coeff(int, char **); double init_one(int, int); - void *extract(const char *, int &); - + void *extract(const char *, int &); + void compute(int, int); void compute_single_pair(int, double *); - void compute_dipolar(int, int, double *, double *, double *, + void compute_dipolar(int, int, double *, double *, double *, double *, double); - void compute_dipolar_mech(int, int, double *, double *, double *, + void compute_dipolar_mech(int, int, double *, double *, double *, double *, double); void write_restart(FILE *); void read_restart(FILE *); void write_restart_settings(FILE *); void read_restart_settings(FILE *); - - double cut_spin_long_global; // global long cutoff distance + + double cut_spin_long_global; // global long cutoff distance protected: double hbar; // reduced Planck's constant diff --git a/src/SPIN/pair_spin_dipole_long.cpp b/src/SPIN/pair_spin_dipole_long.cpp index 3805eb3291..356f73a809 100644 --- a/src/SPIN/pair_spin_dipole_long.cpp +++ b/src/SPIN/pair_spin_dipole_long.cpp @@ -81,9 +81,9 @@ void PairSpinDipoleLong::settings(int narg, char **arg) PairSpin::settings(narg,arg); cut_spin_long_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++) { @@ -103,10 +103,10 @@ void PairSpinDipoleLong::settings(int narg, char **arg) void PairSpinDipoleLong::coeff(int narg, char **arg) { if (!allocated) allocate(); - + if (narg != 3) error->all(FLERR,"Incorrect args in pair_style command"); - + int ilo,ihi,jlo,jhi; force->bounds(FLERR,arg[0],atom->ntypes,ilo,ihi); force->bounds(FLERR,arg[1],atom->ntypes,jlo,jhi); @@ -148,9 +148,9 @@ void PairSpinDipoleLong::init_style() double PairSpinDipoleLong::init_one(int i, int j) { if (setflag[i][j] == 0) error->all(FLERR,"All pair coeffs are not set"); - + cut_spin_long[j][i] = cut_spin_long[i][j]; - + return cut_spin_long_global; } @@ -183,7 +183,7 @@ void *PairSpinDipoleLong::extract(const char *str, int &dim) void PairSpinDipoleLong::compute(int eflag, int vflag) { - int i,j,ii,jj,inum,jnum,itype,jtype; + int i,j,ii,jj,inum,jnum,itype,jtype; double r,rinv,r2inv,rsq; double grij,expm2,t,erfc; double evdwl,ecoul; @@ -193,7 +193,7 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) double fi[3],fmi[3]; double local_cut2; double pre1,pre2,pre3; - int *ilist,*jlist,*numneigh,**firstneigh; + int *ilist,*jlist,*numneigh,**firstneigh; evdwl = ecoul = 0.0; if (eflag || vflag) ev_setup(eflag,vflag); @@ -202,9 +202,9 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) double **x = atom->x; double **f = atom->f; double **fm = atom->fm; - double **sp = atom->sp; - int *type = atom->type; - int nlocal = atom->nlocal; + double **sp = atom->sp; + int *type = atom->type; + int nlocal = atom->nlocal; int newton_pair = force->newton_pair; inum = list->inum; @@ -225,9 +225,9 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) xi[1] = x[i][1]; xi[2] = x[i][2]; jlist = firstneigh[i]; - jnum = numneigh[i]; - spi[0] = sp[i][0]; - spi[1] = sp[i][1]; + jnum = numneigh[i]; + spi[0] = sp[i][0]; + spi[1] = sp[i][1]; spi[2] = sp[i][2]; spi[3] = sp[i][3]; itype = type[i]; @@ -237,17 +237,17 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) j &= NEIGHMASK; jtype = type[j]; - spj[0] = sp[j][0]; - spj[1] = sp[j][1]; - spj[2] = sp[j][2]; - spj[3] = sp[j][3]; + spj[0] = sp[j][0]; + spj[1] = sp[j][1]; + spj[2] = sp[j][2]; + spj[3] = sp[j][3]; evdwl = 0.0; fi[0] = fi[1] = fi[2] = 0.0; fmi[0] = fmi[1] = fmi[2] = 0.0; bij[0] = bij[1] = bij[2] = bij[3] = 0.0; - + rij[0] = x[j][0] - xi[0]; rij[1] = x[j][1] - xi[1]; rij[2] = x[j][2] - xi[2]; @@ -279,22 +279,22 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) // 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] + + evdwl -= spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]; evdwl *= hbar; } @@ -314,21 +314,21 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) { - int j,jj,jnum,itype,jtype,ntypes; + int j,jj,jnum,itype,jtype,ntypes; int k,locflag; - int *jlist,*numneigh,**firstneigh; + int *jlist,*numneigh,**firstneigh; double r,rinv,r2inv,rsq,grij,expm2,t,erfc; double local_cut2,pre1,pre2,pre3; double bij[4],xi[3],rij[3],eij[3],spi[4],spj[4]; - int *type = atom->type; + int *type = atom->type; double **x = atom->x; - double **sp = atom->sp; + double **sp = atom->sp; double **fm_long = atom->fm_long; numneigh = list->numneigh; firstneigh = list->firstneigh; - + // check if interaction applies to type of ii itype = type[ii]; @@ -362,16 +362,16 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) // computation of the exchange interaction // loop over neighbors of atom i - + xi[0] = x[ii][0]; xi[1] = x[ii][1]; xi[2] = x[ii][2]; - spi[0] = sp[ii][0]; - spi[1] = sp[ii][1]; + spi[0] = sp[ii][0]; + spi[1] = sp[ii][1]; spi[2] = sp[ii][2]; spi[3] = sp[ii][3]; jlist = firstneigh[ii]; - jnum = numneigh[ii]; + jnum = numneigh[ii]; //itype = type[i]; for (jj = 0; jj < jnum; jj++) { @@ -379,14 +379,14 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) j &= NEIGHMASK; jtype = type[j]; - spj[0] = sp[j][0]; - spj[1] = sp[j][1]; - spj[2] = sp[j][2]; - spj[3] = sp[j][3]; + spj[0] = sp[j][0]; + spj[1] = sp[j][1]; + spj[2] = sp[j][2]; + spj[3] = sp[j][3]; fmi[0] = fmi[1] = fmi[2] = 0.0; bij[0] = bij[1] = bij[2] = bij[3] = 0.0; - + rij[0] = x[j][0] - xi[0]; rij[1] = x[j][1] - xi[1]; rij[2] = x[j][2] - xi[2]; @@ -417,7 +417,7 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) } // adding the kspace components to fm - + fmi[0] += fm_long[ii][0]; fmi[1] += fm_long[ii][1]; fmi[2] += fm_long[ii][2]; @@ -428,7 +428,7 @@ void PairSpinDipoleLong::compute_single_pair(int ii, double fmi[3]) compute dipolar interaction between spins i and j ------------------------------------------------------------------------- */ -void PairSpinDipoleLong::compute_long(int /* i */, int /* j */, double eij[3], +void PairSpinDipoleLong::compute_long(int /* i */, int /* j */, double eij[3], double bij[4], double fmi[3], double spi[4], double spj[4]) { double sjeij,pre; @@ -447,7 +447,7 @@ void PairSpinDipoleLong::compute_long(int /* i */, int /* j */, double eij[3], } /* ---------------------------------------------------------------------- - compute the mechanical force due to the dipolar interaction between + compute the mechanical force due to the dipolar interaction between atom i and atom j ------------------------------------------------------------------------- */ diff --git a/src/SPIN/pair_spin_dipole_long.h b/src/SPIN/pair_spin_dipole_long.h index 56fd4c7126..1ec30cdb93 100644 --- a/src/SPIN/pair_spin_dipole_long.h +++ b/src/SPIN/pair_spin_dipole_long.h @@ -35,22 +35,22 @@ class PairSpinDipoleLong : public PairSpin { void coeff(int, char **); void init_style(); double init_one(int, int); - void *extract(const char *, int &); - + void *extract(const char *, int &); + void compute(int, int); void compute_single_pair(int, double *); - void compute_long(int, int, double *, double *, double *, + void compute_long(int, int, double *, double *, double *, double *, double *); - void compute_long_mech(int, int, double *, double *, double *, + void compute_long_mech(int, int, double *, double *, double *, double *, double *); void write_restart(FILE *); void read_restart(FILE *); void write_restart_settings(FILE *); void read_restart_settings(FILE *); - - double cut_spin_long_global; // global long cutoff distance + + double cut_spin_long_global; // global long cutoff distance protected: double hbar; // reduced Planck's constant diff --git a/src/USER-CGDNA/pair_oxdna2_excv.cpp b/src/USER-CGDNA/pair_oxdna2_excv.cpp index d8a263676f..dd0f6c9d68 100644 --- a/src/USER-CGDNA/pair_oxdna2_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna2_excv.cpp @@ -35,7 +35,7 @@ PairOxdna2Excv::~PairOxdna2Excv() /* ---------------------------------------------------------------------- compute vector COM-excluded volume interaction sites in oxDNA2 ------------------------------------------------------------------------- */ -void PairOxdna2Excv::compute_interaction_sites(double e1[3], double e2[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_oxdna_coaxstk.cpp b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp index f0777fcdbd..750c6c022d 100644 --- a/src/USER-CGDNA/pair_oxdna_coaxstk.cpp +++ b/src/USER-CGDNA/pair_oxdna_coaxstk.cpp @@ -59,7 +59,7 @@ PairOxdnaCoaxstk::~PairOxdnaCoaxstk() memory->destroy(cut_cxst_hi); memory->destroy(cut_cxst_lc); memory->destroy(cut_cxst_hc); - memory->destroy(cutsq_cxst_hc); + memory->destroy(cutsq_cxst_hc); memory->destroy(b_cxst_lo); memory->destroy(b_cxst_hi); diff --git a/src/USER-CGDNA/pair_oxdna_excv.cpp b/src/USER-CGDNA/pair_oxdna_excv.cpp index 8506f5e3d1..e8e2fad020 100644 --- a/src/USER-CGDNA/pair_oxdna_excv.cpp +++ b/src/USER-CGDNA/pair_oxdna_excv.cpp @@ -86,7 +86,7 @@ PairOxdnaExcv::~PairOxdnaExcv() /* ---------------------------------------------------------------------- compute vector COM-excluded volume interaction sites in oxDNA ------------------------------------------------------------------------- */ -void PairOxdnaExcv::compute_interaction_sites(double e1[3], double /*e2*/[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; diff --git a/src/USER-CGDNA/pair_oxdna_hbond.cpp b/src/USER-CGDNA/pair_oxdna_hbond.cpp index 9e4bb1c273..26042339ea 100644 --- a/src/USER-CGDNA/pair_oxdna_hbond.cpp +++ b/src/USER-CGDNA/pair_oxdna_hbond.cpp @@ -42,7 +42,7 @@ PairOxdnaHbond::PairOxdnaHbond(LAMMPS *lmp) : Pair(lmp) // sequence-specific base-pairing strength // A:0 C:1 G:2 T:3, 5'- [i][j] -3' - + alpha_hb[0][0] = 1.00000; alpha_hb[0][1] = 1.00000; alpha_hb[0][2] = 1.00000; diff --git a/src/USER-CGDNA/pair_oxdna_stk.cpp b/src/USER-CGDNA/pair_oxdna_stk.cpp index 9db554366b..4d1c4a7101 100644 --- a/src/USER-CGDNA/pair_oxdna_stk.cpp +++ b/src/USER-CGDNA/pair_oxdna_stk.cpp @@ -43,7 +43,7 @@ PairOxdnaStk::PairOxdnaStk(LAMMPS *lmp) : Pair(lmp) // sequence-specific stacking strength // A:0 C:1 G:2 T:3, 5'- [i][j] -3' - eta_st[0][0] = 1.11960; + eta_st[0][0] = 1.11960; eta_st[0][1] = 1.00852; eta_st[0][2] = 0.96950; eta_st[0][3] = 0.99632; @@ -121,7 +121,7 @@ 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 + follows the virial incrementation of the bond style. This is because the bond topology is used in the main compute loop. ------------------------------------------------------------------------- */ diff --git a/src/USER-MEAMC/meam_setup_done.cpp b/src/USER-MEAMC/meam_setup_done.cpp index 7000eac6ae..37bfce5873 100644 --- a/src/USER-MEAMC/meam_setup_done.cpp +++ b/src/USER-MEAMC/meam_setup_done.cpp @@ -454,7 +454,7 @@ MEAM::phi_meam(double r, int a, int b) 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], diff --git a/src/USER-MISC/compute_gyration_shape.cpp b/src/USER-MISC/compute_gyration_shape.cpp index 8c660cfb9e..aef5ef91a3 100644 --- a/src/USER-MISC/compute_gyration_shape.cpp +++ b/src/USER-MISC/compute_gyration_shape.cpp @@ -39,7 +39,7 @@ ComputeGyrationShape::ComputeGyrationShape(LAMMPS *lmp, int narg, char **arg) : extscalar = 0; extvector = 0; - // ID of compute gyration + // ID of compute gyration int n = strlen(arg[3]) + 1; id_gyration = new char[n]; strcpy(id_gyration,arg[3]); diff --git a/src/USER-MISC/compute_hma.cpp b/src/USER-MISC/compute_hma.cpp index 56103a42b0..f552126f4f 100644 --- a/src/USER-MISC/compute_hma.cpp +++ b/src/USER-MISC/compute_hma.cpp @@ -78,21 +78,21 @@ 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 (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");} + 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]); + 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 + 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; @@ -100,30 +100,30 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : strcpy(id_fix,id); strcat(id_fix,"_COMPUTE_STORE"); - char **newarg = new char*[6]; + char **newarg = new char*[6]; newarg[0] = id_fix; newarg[1] = group->names[igroup]; - newarg[2] = (char *) "STORE"; + 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; + 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; + if (fix->restart_reset) fix->restart_reset = 0; else { - double **xoriginal = fix->astore; + 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]); + domain->unmap(x[i],image[i],xoriginal[i]); } vector_flag = 1; @@ -175,7 +175,7 @@ ComputeHMA::ComputeHMA(LAMMPS *lmp, int narg, char **arg) : memory->create(vector, size_vector, "hma:vector"); if (computeU>-1 || computeCv>-1) { - peflag = 1; + peflag = 1; } if (computeP>-1) { pressflag = 1; @@ -209,9 +209,9 @@ 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; + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->occasional = 1; } void ComputeHMA::init_list(int /* id */, NeighList *ptr) @@ -224,22 +224,22 @@ 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); + 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; + 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 hma store fix ID"); - fix = (FixStore *) modify->fix[ifix2]; + fix = (FixStore *) modify->fix[ifix2]; } /* ---------------------------------------------------------------------- */ void ComputeHMA::compute_vector() { - invoked_vector = update->ntimestep; + invoked_vector = update->ntimestep; // grow deltaR array if necessary if (comm_forward>0 && atom->nmax > nmax) { @@ -257,7 +257,7 @@ void ComputeHMA::compute_vector() int nlocal = atom->nlocal; double *h = domain->h; - double xprd = domain->xprd; + double xprd = domain->xprd; double yprd = domain->yprd; double zprd = domain->zprd; diff --git a/src/USER-MISC/compute_hma.h b/src/USER-MISC/compute_hma.h index 233e8bbe57..5fc1130c8b 100644 --- a/src/USER-MISC/compute_hma.h +++ b/src/USER-MISC/compute_hma.h @@ -64,4 +64,4 @@ class ComputeHMA : public Compute { #endif #endif - + diff --git a/src/USER-MISC/pair_cosine_squared.cpp b/src/USER-MISC/pair_cosine_squared.cpp index ffa8a6603c..7c0cb3372d 100644 --- a/src/USER-MISC/pair_cosine_squared.cpp +++ b/src/USER-MISC/pair_cosine_squared.cpp @@ -125,7 +125,7 @@ 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(); @@ -459,7 +459,7 @@ double PairCosineSquared::single(int /* i */, int /* j */, int itype, int jtype, double &fforce) { double r, r2inv, r6inv, cosone, force, energy; - + r = sqrt(rsq); if (r <= sigma[itype][jtype]) { @@ -478,7 +478,7 @@ double PairCosineSquared::single(int /* i */, int /* j */, int itype, int 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])) * + 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; } diff --git a/src/USER-MISC/pair_extep.cpp b/src/USER-MISC/pair_extep.cpp index 8507fd49f6..f7670d30b5 100644 --- a/src/USER-MISC/pair_extep.cpp +++ b/src/USER-MISC/pair_extep.cpp @@ -757,7 +757,7 @@ void PairExTeP::read_file(char *file) // skip line if it is a leftover from the previous section, // which can be identified by having 3 elements (instead of 2) // as first words. - + if (isupper(words[0][0]) && isupper(words[1][0]) && isupper(words[2][0])) continue; diff --git a/src/USER-MISC/pair_ilp_graphene_hbn.cpp b/src/USER-MISC/pair_ilp_graphene_hbn.cpp index 9faa350468..e998abf005 100644 --- a/src/USER-MISC/pair_ilp_graphene_hbn.cpp +++ b/src/USER-MISC/pair_ilp_graphene_hbn.cpp @@ -442,7 +442,7 @@ void PairILPGrapheneHBN::compute(int eflag, int vflag) if (vflag_fdotr) virial_fdotr_compute(); } -/* ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- van der Waals forces and energy ------------------------------------------------------------------------- */ @@ -540,7 +540,7 @@ void PairILPGrapheneHBN::calc_FvdW(int eflag, int /* vflag */) } } -/* ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- Repulsive forces and energy ------------------------------------------------------------------------- */ diff --git a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp index d0d8517550..eea0b1261c 100644 --- a/src/USER-MISC/pair_kolmogorov_crespi_full.cpp +++ b/src/USER-MISC/pair_kolmogorov_crespi_full.cpp @@ -444,7 +444,7 @@ void PairKolmogorovCrespiFull::compute(int eflag, int vflag) if (vflag_fdotr) virial_fdotr_compute(); } -/* ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- van der Waals forces and energy ------------------------------------------------------------------------- */ @@ -540,7 +540,7 @@ void PairKolmogorovCrespiFull::calc_FvdW(int eflag, int /* vflag */) } } -/* ---------------------------------------------------------------------- +/* ---------------------------------------------------------------------- Repulsive forces and energy ------------------------------------------------------------------------- */ @@ -790,7 +790,7 @@ void PairKolmogorovCrespiFull::calc_normal() memory->create(dnormal,3,3,3,nmax,"KolmogorovCrespiFull:dnormal"); } - inum = list->inum; + inum = list->inum; ilist = list->ilist; //Calculate normals for (ii = 0; ii < inum; ii++) { diff --git a/src/USER-MISC/pair_local_density.cpp b/src/USER-MISC/pair_local_density.cpp index 1e4ad3edf6..8ad9793f98 100644 --- a/src/USER-MISC/pair_local_density.cpp +++ b/src/USER-MISC/pair_local_density.cpp @@ -61,9 +61,9 @@ static const char cite_pair_local_density[] = PairLocalDensity::PairLocalDensity(LAMMPS *lmp) : Pair(lmp) { restartinfo = 0; - one_coeff = 1; + one_coeff = 1; single_enable = 1; - + // stuff read from tabulated file nLD = 0; nrho = 0; @@ -81,14 +81,14 @@ PairLocalDensity::PairLocalDensity(LAMMPS *lmp) : Pair(lmp) lowercutsq = NULL; frho = NULL; rho = NULL; - + // splined arrays frho_spline = NULL; - + // per-atom arrays nmax = 0; fp = NULL; - localrho = NULL; + localrho = NULL; // set comm size needed by this pair comm_forward = 1; @@ -114,10 +114,10 @@ PairLocalDensity::~PairLocalDensity() } memory->destroy(frho_spline); - - memory->destroy(rho_min); + + memory->destroy(rho_min); memory->destroy(rho_max); - memory->destroy(delta_rho); + memory->destroy(delta_rho); memory->destroy(c0); memory->destroy(c2); memory->destroy(c4); @@ -137,37 +137,37 @@ PairLocalDensity::~PairLocalDensity() void PairLocalDensity::compute(int eflag, int vflag) { - + int i,j,ii,jj,m,k,inum,jnum,itype,jtype; double xtmp,ytmp,ztmp,delx,dely,delz,rsq; double rsqinv, phi, uLD, dphi, evdwl,fpair; double p, *coeff; int *ilist,*jlist,*numneigh,**firstneigh; - phi = uLD = evdwl = fpair = rsqinv = 0.0; + phi = uLD = evdwl = fpair = rsqinv = 0.0; if (eflag || vflag) ev_setup(eflag,vflag); else evflag = vflag_fdotr = eflag_global = eflag_atom = 0; /* localrho = LD at each atom fp = derivative of embedding energy at each atom for each LD potential - uLD = embedding energy of each atom due to each LD potential*/ - + uLD = embedding energy of each atom due to each LD potential*/ + // grow LD and fp arrays if necessary // need to be atom->nmax in length - + if (atom->nmax > nmax) { memory->destroy(localrho); memory->destroy(fp); - nmax = atom->nmax; + nmax = atom->nmax; memory->create(localrho, nLD, nmax, "pairLD:localrho"); memory->create(fp, nLD, nmax, "pairLD:fp"); } - double **x = atom->x; + double **x = atom->x; double **f = atom->f; - int *type = atom->type; - int nlocal = atom->nlocal; + int *type = atom->type; + int nlocal = atom->nlocal; int newton_pair = force->newton_pair; inum = list->inum; @@ -179,13 +179,13 @@ void PairLocalDensity::compute(int eflag, int vflag) if (newton_pair) { m = nlocal + atom->nghost; - for (k = 0; k < nLD; k++) { - for (i = 0; i < m; i++) { + for (k = 0; k < nLD; k++) { + for (i = 0; i < m; i++) { localrho[k][i] = 0.0; fp[k][i] = 0.0; } - } - } + } + } else { for (k = 0; k < nLD; k++){ for (i = 0; i < nlocal; i++) { @@ -196,7 +196,7 @@ void PairLocalDensity::compute(int eflag, int vflag) } // loop over neighs of central atoms and types of LDs - + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; xtmp = x[i][0]; @@ -205,19 +205,19 @@ void PairLocalDensity::compute(int eflag, int vflag) itype = type[i]; jlist = firstneigh[i]; jnum = numneigh[i]; - + for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; j &= NEIGHMASK; - jtype = type[j]; + jtype = type[j]; // calculate distance-squared between i,j atom-types - + delx = xtmp - x[j][0]; dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; - rsq = delx*delx + dely*dely + delz*delz; - + rsq = delx*delx + dely*dely + delz*delz; + // calculating LDs based on central and neigh filters for (k = 0; k < nLD; k++) { @@ -230,36 +230,36 @@ void PairLocalDensity::compute(int eflag, int vflag) else { phi = c0[k] + rsq * (c2[k] + rsq * (c4[k] + c6[k]*rsq)); } - localrho[k][i] += (phi * b[k][jtype]); - - /*checking for both i,j is necessary + localrho[k][i] += (phi * b[k][jtype]); + + /*checking for both i,j is necessary since a half neighbor list is processed.*/ - + if (newton_pair || jreverse_comm_pair(this); - // + // - for (ii = 0; ii < inum; ii++) { + for (ii = 0; ii < inum; ii++) { i = ilist[ii]; itype = type[i]; - uLD = 0.0; + uLD = 0.0; for (k = 0; k < nLD; k++) { - /*skip over this loop if the LD potential + /*skip over this loop if the LD potential is not intendend for central atomtype */ - if (!(a[k][itype])) continue; - + if (!(a[k][itype])) continue; + // linear extrapolation at rho_min and rho_max - + if (localrho[k][i] <= rho_min[k]) { coeff = frho_spline[k][0]; fp[k][i] = coeff[2]; @@ -284,14 +284,14 @@ void PairLocalDensity::compute(int eflag, int vflag) if (eflag) { if (eflag_global) eng_vdwl += uLD; - if (eflag_atom) eatom[i] += uLD; + if (eflag_atom) eatom[i] += uLD; } } // communicate LD and fp to all procs comm->forward_comm_pair(this); - + // compute forces on each atom // loop over neighbors of my atoms @@ -306,7 +306,7 @@ void PairLocalDensity::compute(int eflag, int vflag) jnum = numneigh[i]; for (jj = 0; jj < jnum; jj++) { - j = jlist[jj]; + j = jlist[jj]; j &= NEIGHMASK; jtype = type[j]; @@ -316,19 +316,19 @@ void PairLocalDensity::compute(int eflag, int vflag) dely = ytmp - x[j][1]; delz = ztmp - x[j][2]; rsq = delx*delx + dely*dely + delz*delz; - - // calculate force between two atoms + + // calculate force between two atoms fpair = 0.0; if (rsq < cutforcesq) { // global cutoff check rsqinv = 1.0/rsq; for (k = 0; k < nLD; k++) { if (rsq >= lowercutsq[k] && rsq < uppercutsq[k]) { dphi = rsq * (2.0*c2[k] + rsq * (4.0*c4[k] + 6.0*c6[k]*rsq)); - fpair += -(a[k][itype]*b[k][jtype]*fp[k][i] + a[k][jtype]*b[k][itype]*fp[k][j]) * dphi; + fpair += -(a[k][itype]*b[k][jtype]*fp[k][i] + a[k][jtype]*b[k][itype]*fp[k][j]) * dphi; } - } - fpair *= rsqinv; - + } + fpair *= rsqinv; + f[i][0] += delx*fpair; f[i][1] += dely*fpair; f[i][2] += delz*fpair; @@ -337,19 +337,19 @@ void PairLocalDensity::compute(int eflag, int vflag) f[j][1] -= dely*fpair; f[j][2] -= delz*fpair; } - - /*eng_vdwl has already been completely built, + + /*eng_vdwl has already been completely built, so no need to add anything here*/ - + if (eflag) evdwl = 0.0; - + if (evflag) ev_tally(i,j,nlocal,newton_pair, evdwl,0.0,fpair,delx,dely,delz); } } } - + if (vflag_fdotr) virial_fdotr_compute(); } @@ -362,7 +362,7 @@ void PairLocalDensity::allocate() { allocated = 1; int n = atom->ntypes; - + memory->create(cutsq,n+1,n+1,"pair:cutsq"); memory->create(setflag,n+1,n+1,"pair:setflag"); @@ -430,7 +430,7 @@ void PairLocalDensity::init_style() // request half neighbor list array2spline(); - + // half neighbor request neighbor->request(this); } @@ -446,7 +446,7 @@ double PairLocalDensity::init_one(int /* i */, int /* j */) cutmax = 0.0; for (int k = 0; k < nLD; k++) cutmax = MAX(cutmax,uppercut[k]); - + cutforcesq = cutmax*cutmax; return cutmax; @@ -454,7 +454,7 @@ double PairLocalDensity::init_one(int /* i */, int /* j */) /*-------------------------------------------------------------------------- - pair_write functionality for this pair style that gives just a snap-shot + pair_write functionality for this pair style that gives just a snap-shot of the LD potential without doing an actual MD run ---------------------------------------------------------------------------*/ @@ -473,7 +473,7 @@ double PairLocalDensity::single(int /* i */, int /* j */, int itype, int jtype, for (k = 0; k < nLD; k++) { LD[k][1] = 0.0; // itype:- 1 LD[k][2] = 0.0; // jtype:- 2 - } + } rsqinv = 1.0/rsq; for (k = 0; k < nLD; k++) { @@ -487,13 +487,13 @@ double PairLocalDensity::single(int /* i */, int /* j */, int itype, int jtype, phi = c0[k] + rsq * (c2[k] + rsq * (c4[k] + c6[k]*rsq)); } LD[k][1] += (phi * b[k][jtype]); - LD[k][2] += (phi * b[k][itype]); + LD[k][2] += (phi * b[k][itype]); } for (k = 0; k < nLD; k++) { if (a[k][itype]) index = 1; if (a[k][jtype]) index = 2; - + if (LD[k][index] <= rho_min[k]) { coeff = frho_spline[k][0]; dFdrho = coeff[2]; @@ -545,43 +545,43 @@ void PairLocalDensity::array2spline() { } -/* ---------------------------------------------------------------------- - (one-dimensional) cubic spline interpolation sub-routine, - which determines the coeffs for a clamped cubic spline +/* ---------------------------------------------------------------------- + (one-dimensional) cubic spline interpolation sub-routine, + which determines the coeffs for a clamped cubic spline given tabulated data ------------------------------------------------------------------------*/ -void PairLocalDensity::interpolate_cbspl(int n, double delta, - double *f, double **spline) +void PairLocalDensity::interpolate_cbspl(int n, double delta, + double *f, double **spline) { /* inputs: n number of interpolating points - + f array containing function values to be interpolated; f[i] is the function value corresponding to x[i] ('x' refers to the independent var) - + delta difference in tabulated values of x - + outputs: (packaged as columns of the coeff matrix) coeff_b coeffs of linear terms coeff_c coeffs of quadratic terms coeff_d coeffs of cubic terms spline matrix that collects b,c,d - - + + other parameters: fpa derivative of function at x=a fpb derivative of function at x=b */ - + double *dl, *dd, *du; double *coeff_b, *coeff_c, *coeff_d; double fpa, fpb; int i; - + coeff_b = new double [n]; coeff_c = new double [n]; coeff_d = new double [n]; @@ -598,11 +598,11 @@ void PairLocalDensity::interpolate_cbspl(int n, double delta, // set slopes at beginning and end fpa = 0.; fpb = 0.; - + for ( i = 0; i < n-1; i++ ) { dl[i] = du[i] = delta; } - + dd[0] = 2.0 * delta; dd[n-1] = 2.0 * delta; coeff_c[0] = ( 3.0 / delta ) * ( f[1] - f[0] ) - 3.0 * fpa; @@ -612,20 +612,20 @@ void PairLocalDensity::interpolate_cbspl(int n, double delta, coeff_c[i+1] = ( 3.0 / delta ) * ( f[i+2] - f[i+1] ) - ( 3.0 / delta ) * ( f[i+1] - f[i] ); } - + // tridiagonal solver for ( i = 0; i < n-1; i++ ) { du[i] /= dd[i]; dd[i+1] -= dl[i]*du[i]; } - + coeff_c[0] /= dd[0]; for ( i = 1; i < n; i++ ) coeff_c[i] = ( coeff_c[i] - dl[i-1] * coeff_c[i-1] ) / dd[i]; - + for ( i = n-2; i >= 0; i-- ) coeff_c[i] -= coeff_c[i+1] * du[i]; - + for ( i = 0; i < n-1; i++ ) { coeff_d[i] = ( coeff_c[i+1] - coeff_c[i] ) / ( 3.0 * delta ); coeff_b[i] = ( f[i+1] - f[i] ) / delta - delta * ( coeff_c[i+1] + 2.0*coeff_c[i] ) / 3.0; @@ -648,7 +648,7 @@ void PairLocalDensity::interpolate_cbspl(int n, double delta, spline[i][1] = 2.0*spline[i][4]/delta; spline[i][0] = 3.0*spline[i][3]/delta; } - + delete [] coeff_b; delete [] coeff_c; delete [] coeff_d; @@ -662,7 +662,7 @@ void PairLocalDensity::interpolate_cbspl(int n, double delta, ------------------------------------------------------------------------- */ void PairLocalDensity::parse_file(char *filename) { - + int k, n; int me = comm->me; FILE *fptr; @@ -680,23 +680,23 @@ void PairLocalDensity::parse_file(char *filename) { } double *ftmp; // tmp var to extract the complete 2D frho array from file - + // broadcast number of LD potentials and number of (rho,frho) pairs if (me == 0) { - - // first 2 comment lines ignored + + // first 2 comment lines ignored utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); - + // extract number of potentials and number of (frho, rho) points - utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); + utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); sscanf(line, "%d %d", &nLD, &nrho); utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); } MPI_Bcast(&nLD,1,MPI_INT,0,world); MPI_Bcast(&nrho,1,MPI_INT,0,world); - + // setting up all arrays to be read from files and broadcasted memory->create(uppercut, nLD, "pairLD:uppercut"); memory->create(lowercut, nLD, "pairLD:lowercut"); @@ -706,14 +706,14 @@ void PairLocalDensity::parse_file(char *filename) { memory->create(c2, nLD, "pairLD:c2"); memory->create(c4, nLD, "pairLD:c4"); memory->create(c6, nLD, "pairLD:c6"); - memory->create(rho_min, nLD, "pairLD:rho_min"); + memory->create(rho_min, nLD, "pairLD:rho_min"); memory->create(rho_max, nLD, "pairLD:rho_max"); memory->create(delta_rho, nLD,"pairLD:delta_rho"); memory->create(ftmp, nrho*nLD, "pairLD:ftmp"); - - // setting up central and neighbor atom filters + + // setting up central and neighbor atom filters memory->create(a, nLD, atom->ntypes+1 , "pairLD:a"); - memory->create(b, nLD, atom->ntypes+1, "pairLD:b"); + memory->create(b, nLD, atom->ntypes+1, "pairLD:b"); if (me == 0) { for (n = 1; n <= atom->ntypes; n++){ for (k = 0; k < nLD; k++) { @@ -721,17 +721,17 @@ void PairLocalDensity::parse_file(char *filename) { b[k][n] = 0; } } - } - + } + // read file block by block - + if (me == 0) { for (k = 0; k < nLD; k++) { - - // parse upper and lower cut values + + // parse upper and lower cut values if (fgets(line,MAXLINE,fptr)==NULL) break; sscanf(line, "%lf %lf", &lowercut[k], &uppercut[k]); - + // parse and broadcast central atom filter utils::sfgets(FLERR,line, MAXLINE, fptr,filename,error); char *tmp = strtok(line, " /t/n/r/f"); @@ -739,27 +739,27 @@ void PairLocalDensity::parse_file(char *filename) { a[k][atoi(tmp)] = 1; tmp = strtok(NULL, " /t/n/r/f"); } - + // parse neighbor atom filter utils::sfgets(FLERR,line, MAXLINE, fptr,filename,error); tmp = strtok(line, " /t/n/r/f"); - while (tmp != NULL) { + while (tmp != NULL) { b[k][atoi(tmp)] = 1; tmp = strtok(NULL, " /t/n/r/f"); } - + // parse min, max and delta rho values utils::sfgets(FLERR,line, MAXLINE, fptr,filename,error); sscanf(line, "%lf %lf %lf", &rho_min[k], &rho_max[k], &delta_rho[k]); // recompute delta_rho from scratch for precision delta_rho[k] = (rho_max[k] - rho_min[k]) / (nrho - 1); - + // parse tabulated frho values from each line into temporary array - for (n = 0; n < nrho; n++) { + for (n = 0; n < nrho; n++) { utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); sscanf(line, "%lf", &ftmp[k*nrho + n]); } - + // ignore blank line at the end of every block utils::sfgets(FLERR,line,MAXLINE,fptr,filename,error); @@ -778,7 +778,7 @@ void PairLocalDensity::parse_file(char *filename) { } } - // Broadcast all parsed arrays + // Broadcast all parsed arrays MPI_Bcast(&lowercut[0], nLD, MPI_DOUBLE, 0, world); MPI_Bcast(&uppercut[0], nLD, MPI_DOUBLE, 0, world); MPI_Bcast(&lowercutsq[0], nLD, MPI_DOUBLE, 0, world); @@ -800,8 +800,8 @@ void PairLocalDensity::parse_file(char *filename) { // set up rho and frho arrays memory->create(rho, nLD, nrho, "pairLD:rho"); - memory->create(frho, nLD, nrho, "pairLD:frho"); - + memory->create(frho, nLD, nrho, "pairLD:frho"); + for (k = 0; k < nLD; k++) { for (n = 0; n < nrho; n++) { rho[k][n] = rho_min[k] + n*delta_rho[k]; @@ -812,7 +812,7 @@ void PairLocalDensity::parse_file(char *filename) { // delete temporary array memory->destroy(ftmp); } - + /* ---------------------------------------------------------------------- communication routines ------------------------------------------------------------------------- */ @@ -820,16 +820,16 @@ void PairLocalDensity::parse_file(char *filename) { int PairLocalDensity::pack_comm(int n, int *list, double *buf, int /* pbc_flag */, int * /* pbc */) { int i,j,k; - int m; + int m; m = 0; for (i = 0; i < n; i++) { - j = list[i]; + j = list[i]; for (k = 0; k < nLD; k++) { - buf[m++] = fp[k][j]; - } + buf[m++] = fp[k][j]; + } } - + return nLD; } @@ -838,14 +838,14 @@ int PairLocalDensity::pack_comm(int n, int *list, double *buf, void PairLocalDensity::unpack_comm(int n, int first, double *buf) { int i,k,m,last; - + m = 0; last = first + n; for (i = first; i < last; i++) { for (k = 0; k < nLD; k++) { fp[k][i] = buf[m++]; } - } + } } /* ---------------------------------------------------------------------- */ @@ -876,7 +876,7 @@ void PairLocalDensity::unpack_reverse_comm(int n, int *list, double *buf) { j = list[i]; for (k = 0; k < nLD; k++) { localrho[k][j] += buf[m++]; - } + } } } diff --git a/src/USER-MISC/pair_local_density.h b/src/USER-MISC/pair_local_density.h index 5e37376ece..e999352680 100644 --- a/src/USER-MISC/pair_local_density.h +++ b/src/USER-MISC/pair_local_density.h @@ -13,8 +13,8 @@ pair_LocalDensity written by: Tanmoy Sanyal and M. Scott Shell from UC Santa Barbara David Rosenberger: TU Darmstadt --------------------------------------------------------------------------*/ - +-------------------------------------------------------------------------*/ + #ifdef PAIR_CLASS @@ -40,7 +40,7 @@ class PairLocalDensity : public Pair { void init_style(); double init_one(int, int); double single(int, int, int, int, double, double, double, double &); - + virtual int pack_comm(int, int *, double *, int, int *); virtual void unpack_comm(int, int, double *); int pack_reverse_comm(int, int, double *); @@ -51,7 +51,7 @@ class PairLocalDensity : public Pair { protected: //------------------------------------------------------------------------ //This information is read from the tabulated input file - + int nLD, nrho; // number of LD types int **a, **b; // central and neigh atom filters double *uppercut, *lowercut; // upper and lower cutoffs @@ -59,25 +59,25 @@ class PairLocalDensity : public Pair { double *c0, *c2, *c4, *c6; // coeffs for indicator function double *rho_min, *rho_max, *delta_rho; // min, max & grid-size for LDs double **rho, **frho; // LD and LD function tables - + //------------------------------------------------------------------------ - + double ***frho_spline; // splined LD potentials double cutmax; // max cutoff for all elements double cutforcesq; // square of global upper cutoff - + int nmax; // max size of per-atom arrays double **localrho; // per-atom LD double **fp; // per-atom LD potential function derivative - + void allocate(); - + // read tabulated input file void parse_file(char *); - + // convert array to spline void array2spline(); - + // cubic spline interpolation void interpolate_cbspl(int, double, double *, double **); }; diff --git a/src/USER-MOLFILE/reader_molfile.cpp b/src/USER-MOLFILE/reader_molfile.cpp index 5cff56753b..292a451a87 100644 --- a/src/USER-MOLFILE/reader_molfile.cpp +++ b/src/USER-MOLFILE/reader_molfile.cpp @@ -282,7 +282,7 @@ bigint ReaderMolfile::read_header(double box[3][3], int &boxinfo, int &triclinic } // if no field info requested, just return - + if (!fieldinfo) return natoms; memory->create(fieldindex,nfield,"read_dump:fieldindex"); diff --git a/src/USER-PHONON/dynamical_matrix.cpp b/src/USER-PHONON/dynamical_matrix.cpp index fe266fba76..1495219124 100644 --- a/src/USER-PHONON/dynamical_matrix.cpp +++ b/src/USER-PHONON/dynamical_matrix.cpp @@ -259,7 +259,7 @@ void DynamicalMatrix::calculateMatrix() fprintf(screen," Atoms in group = " BIGINT_FORMAT "\n", gcount); fprintf(screen," Total dynamical matrix elements = " BIGINT_FORMAT "\n", (dynlen*dynlen) ); } - + // emit dynlen rows of dimalpha*dynlen*dimbeta elements update->nsteps = 0; diff --git a/src/USER-PLUMED/fix_plumed.cpp b/src/USER-PLUMED/fix_plumed.cpp index c75a48f9b4..b02de2af0d 100644 --- a/src/USER-PLUMED/fix_plumed.cpp +++ b/src/USER-PLUMED/fix_plumed.cpp @@ -411,7 +411,7 @@ void FixPlumed::post_force(int /* vflag */) // pass all pointers to plumed: p->cmd("setStep",&step); - int plumedStopCondition=0; + int plumedStopCondition=0; p->cmd("setStopFlag",&plumedStopCondition); p->cmd("setPositions",&atom->x[0][0]); p->cmd("setBox",&box[0][0]); diff --git a/src/USER-REAXC/reaxc_ffield.cpp b/src/USER-REAXC/reaxc_ffield.cpp index a44c7d5cbd..c8e097eb1c 100644 --- a/src/USER-REAXC/reaxc_ffield.cpp +++ b/src/USER-REAXC/reaxc_ffield.cpp @@ -154,7 +154,7 @@ char Read_Force_Field( FILE *fp, reax_interaction *reax, /* Sanity checks */ if (c == 2 && !lgflag) - control->error_ptr->all(FLERR, "Force field file requires using 'lgvdw yes'"); + control->error_ptr->all(FLERR, "Force field file requires using 'lgvdw yes'"); if (c < 9) { snprintf (errmsg, 1024, "Missing parameter(s) in line %s", s); diff --git a/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp b/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp index 77a25db7cc..022b93a0d2 100644 --- a/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp +++ b/src/USER-YAFF/pair_lj_switch3_coulgauss_long.cpp @@ -133,7 +133,7 @@ void PairLJSwitch3CoulGaussLong::compute(int eflag, int vflag) if (rsq < cutsq[itype][jtype]) { r2inv = 1.0/rsq; - + if (rsq < cut_coulsq) { if (!ncoultablebits || rsq <= tabinnersq) { r = sqrt(rsq); @@ -202,7 +202,7 @@ void PairLJSwitch3CoulGaussLong::compute(int eflag, int vflag) if (r>cut_lj[itype][jtype]-truncw) { trx = (cut_lj[itype][jtype]-r)*truncwi; tr = trx*trx*(3.0-2.0*trx); - ftr = 6.0*trx*(1.0-trx)*r*truncwi; + ftr = 6.0*trx*(1.0-trx)*r*truncwi; forcelj = forcelj*tr + evdwl*ftr; evdwl *= tr; } @@ -683,7 +683,7 @@ double PairLJSwitch3CoulGaussLong::single(int i, int j, int itype, int jtype, if (r>cut_lj[itype][jtype]-truncw) { trx = (cut_lj[itype][jtype]-r)*truncwi; tr = trx*trx*(3.0-2.0*trx); - ftr = 6.0*trx*(1.0-trx)*r*truncwi; + ftr = 6.0*trx*(1.0-trx)*r*truncwi; forcelj = forcelj*tr + evdwl*ftr; evdwl *= tr; } diff --git a/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp b/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp index 3a4a49c880..6b0466cd6d 100644 --- a/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp +++ b/src/USER-YAFF/pair_mm3_switch3_coulgauss_long.cpp @@ -133,7 +133,7 @@ void PairMM3Switch3CoulGaussLong::compute(int eflag, int vflag) if (rsq < cutsq[itype][jtype]) { r2inv = 1.0/rsq; - + if (rsq < cut_coulsq) { if (!ncoultablebits || rsq <= tabinnersq) { r = sqrt(rsq); @@ -204,7 +204,7 @@ void PairMM3Switch3CoulGaussLong::compute(int eflag, int vflag) if (r>cut_lj[itype][jtype]-truncw) { trx = (cut_lj[itype][jtype]-r)*truncwi; tr = trx*trx*(3.0-2.0*trx); - ftr = 6.0*trx*(1.0-trx)*r*truncwi; + ftr = 6.0*trx*(1.0-trx)*r*truncwi; forcelj = forcelj*tr + evdwl*ftr; evdwl *= tr; } @@ -683,7 +683,7 @@ double PairMM3Switch3CoulGaussLong::single(int i, int j, int itype, int jtype, if (r>cut_lj[itype][jtype]-truncw) { trx = (cut_lj[itype][jtype]-r)*truncwi; tr = trx*trx*(3.0-2.0*trx); - ftr = 6.0*trx*(1.0-trx)*r*truncwi; + ftr = 6.0*trx*(1.0-trx)*r*truncwi; forcelj = forcelj*tr + evdwl*ftr; evdwl *= tr; } diff --git a/src/comm.cpp b/src/comm.cpp index fa6790e0ec..9a577c0e4f 100644 --- a/src/comm.cpp +++ b/src/comm.cpp @@ -673,7 +673,7 @@ double Comm::get_comm_cutoff() // 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 (!force->pair && (cutghostuser == 0.0)) { maxcommcutoff = MAX(maxcommcutoff,maxbondcutoff); } else { diff --git a/src/compute_bond_local.cpp b/src/compute_bond_local.cpp index e14f188e62..010e8db627 100644 --- a/src/compute_bond_local.cpp +++ b/src/compute_bond_local.cpp @@ -130,7 +130,7 @@ ComputeBondLocal::ComputeBondLocal(LAMMPS *lmp, int narg, char **arg) : singleflag = 0; velflag = 0; for (int i = 0; i < nvalues; i++) { - if (bstyle[i] == ENGPOT || bstyle[i] == FORCE || bstyle[i] == FX || + if (bstyle[i] == ENGPOT || bstyle[i] == FORCE || bstyle[i] == FX || bstyle[i] == FY || bstyle[i] == FZ) singleflag = 1; if (bstyle[i] == VELVIB || bstyle[i] == OMEGA || bstyle[i] == ENGTRANS || bstyle[i] == ENGVIB || bstyle[i] == ENGROT) velflag = 1; diff --git a/src/compute_orientorder_atom.cpp b/src/compute_orientorder_atom.cpp index 0a78356127..dcb104fc3a 100644 --- a/src/compute_orientorder_atom.cpp +++ b/src/compute_orientorder_atom.cpp @@ -493,7 +493,7 @@ void ComputeOrientOrderAtom::calc_boop(double **rlist, } // calculate Q_l - // NOTE: optional W_l_hat and components of Q_qlcomp use these stored Q_l values + // NOTE: optional W_l_hat and components of Q_qlcomp use these stored Q_l values int jj = 0; for (int il = 0; il < nqlist; il++) { @@ -505,7 +505,7 @@ void ComputeOrientOrderAtom::calc_boop(double **rlist, qn[jj++] = qnormfac * sqrt(qm_sum); } - // TODO: + // TODO: // 1. [done]Need to allocate extra memory in qnarray[] for this option // 2. [done]Need to add keyword option // 3. [done]Need to caclulate Clebsch-Gordan/Wigner 3j coefficients @@ -673,7 +673,7 @@ void ComputeOrientOrderAtom::init_clebsch_gordan() for(int m2 = MAX(0,l-m1); m2 < MIN(2*l+1,3*l-m1+1); m2++) { bb2 = m2 - l; m = aa2 + bb2 + l; - + sum = 0.0; for (int z = MAX(0, MAX(-aa2, bb2)); z <= MIN(l, MIN(l - aa2, l + bb2)); z++) { @@ -686,7 +686,7 @@ void ComputeOrientOrderAtom::init_clebsch_gordan() factorial(aa2 + z) * factorial(-bb2 + z)); } - + cc2 = m - l; sfaccg = sqrt(factorial(l + aa2) * factorial(l - aa2) * @@ -695,7 +695,7 @@ void ComputeOrientOrderAtom::init_clebsch_gordan() factorial(l + cc2) * factorial(l - cc2) * (2*l + 1)); - + sfac1 = factorial(3*l + 1); sfac2 = factorial(l); dcg = sqrt(sfac2*sfac2*sfac2 / sfac1); diff --git a/src/fix_neigh_history.cpp b/src/fix_neigh_history.cpp index 673e2b1c06..86865ba316 100644 --- a/src/fix_neigh_history.cpp +++ b/src/fix_neigh_history.cpp @@ -407,7 +407,7 @@ void FixNeighHistory::pre_exchange_newton() m = npartner[j]++; partner[j][m] = tag[i]; jvalues = &valuepartner[j][dnum*m]; - if (pair->nondefault_history_transfer) + if (pair->nondefault_history_transfer) pair->transfer_history(onevalues,jvalues); else for (n = 0; n < dnum; n++) jvalues[n] = -onevalues[n]; } @@ -521,7 +521,7 @@ void FixNeighHistory::pre_exchange_no_newton() m = npartner[j]++; partner[j][m] = tag[i]; jvalues = &valuepartner[j][dnum*m]; - if (pair->nondefault_history_transfer) + if (pair->nondefault_history_transfer) pair->transfer_history(onevalues, jvalues); else for (n = 0; n < dnum; n++) jvalues[n] = -onevalues[n]; } diff --git a/src/input.h b/src/input.h index 4b274c17a9..b4df0f0160 100644 --- a/src/input.h +++ b/src/input.h @@ -39,7 +39,7 @@ class Input : protected Pointers { // 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 diff --git a/src/lammps.cpp b/src/lammps.cpp index b3f420b03d..a2d405855d 100644 --- a/src/lammps.cpp +++ b/src/lammps.cpp @@ -1013,7 +1013,7 @@ void _noopt LAMMPS::init_pkg_lists() #undef REGION_CLASS } -bool LAMMPS::is_installed_pkg(const char *pkg) +bool LAMMPS::is_installed_pkg(const char *pkg) { for (int i=0; installed_packages[i] != NULL; ++i) if (strcmp(installed_packages[i],pkg) == 0) return true; diff --git a/src/min.cpp b/src/min.cpp index 5721d5ab3e..3b60f2c2e6 100644 --- a/src/min.cpp +++ b/src/min.cpp @@ -898,7 +898,7 @@ double Min::total_torque() MPI_Allreduce(&ftotsqone,&ftotsqall,1,MPI_DOUBLE,MPI_SUM,world); // multiply it by hbar so that units are in eV - + return sqrt(ftotsqall) * hbar; } diff --git a/src/min.h b/src/min.h index 6f3e10d048..874c7b773d 100644 --- a/src/min.h +++ b/src/min.h @@ -47,8 +47,8 @@ class Min : protected Pointers { // methods for spin minimizers double total_torque(); - double inf_torque(); - double max_torque(); + double inf_torque(); + double max_torque(); virtual void init_style() {} virtual void setup_style() = 0; @@ -65,7 +65,7 @@ class Min : protected Pointers { int external_force_clear; // clear forces locally or externally double dmax; // max dist to move any atom in one step - int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero + int linestyle; // 0 = backtrack, 1 = quadratic, 2 = forcezero // 3 = spin_cubic, 4 = spin_none int normstyle; // TWO, MAX or INF flag for force norm evaluation diff --git a/src/min_cg.cpp b/src/min_cg.cpp index 7b7046ea00..c2c9c1318e 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -91,7 +91,7 @@ int MinCG::iterate(int maxiter) dot[0] += fvec[i]*fvec[i]; dot[1] += fvec[i]*g[i]; } - + if (nextra_atom) for (m = 0; m < nextra_atom; m++) { fatom = fextra_atom[m]; @@ -119,7 +119,7 @@ int MinCG::iterate(int maxiter) if (fmax < update->ftol*update->ftol) return FTOL; } else if (normstyle == TWO) { // Euclidean force 2-norm if (dotall[0] < update->ftol*update->ftol) return FTOL; - } else error->all(FLERR,"Illegal min_modify command"); + } else error->all(FLERR,"Illegal min_modify command"); // update new search direction h from new f = -Grad(x) and old g // this is Polak-Ribieri formulation diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 2c77a13258..eceb34c437 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -1941,7 +1941,7 @@ int Neighbor::decide() conservative shrink procedure: compute distance each of 8 corners of box has moved since last reneighbor reduce skin distance by sum of 2 largest of the 8 values - if reduced skin distance is negative, set to zero + if reduced skin distance is negative, set to zero new trigger = 1/2 of reduced skin distance for orthogonal box, only need 2 lo/hi corners for triclinic, need all 8 corners since deformations can displace all 8 @@ -1963,7 +1963,7 @@ int Neighbor::check_distance() delz = bboxhi[2] - boxhi_hold[2]; delta2 = sqrt(delx*delx + dely*dely + delz*delz); delta = 0.5 * (skin - (delta1+delta2)); - if (delta < 0.0) delta = 0.0; + if (delta < 0.0) delta = 0.0; deltasq = delta*delta; } else { domain->box_corners(); @@ -1977,7 +1977,7 @@ int Neighbor::check_distance() else if (delta > delta2) delta2 = delta; } delta = 0.5 * (skin - (delta1+delta2)); - if (delta < 0.0) delta = 0.0; + if (delta < 0.0) delta = 0.0; deltasq = delta*delta; } } else deltasq = triggersq; diff --git a/src/read_data.cpp b/src/read_data.cpp index 1208ab4b43..d558b87633 100644 --- a/src/read_data.cpp +++ b/src/read_data.cpp @@ -2151,7 +2151,7 @@ void ReadData::parse_coeffs(char *line, const char *addstr, // to avoid segfaults on empty lines if (narg == 0) return; - + if (noffset) { int value = force->inumeric(FLERR,arg[0]); sprintf(argoffset1,"%d",value+offset); diff --git a/src/read_dump.cpp b/src/read_dump.cpp index 7316a2f5cd..dd9395c092 100644 --- a/src/read_dump.cpp +++ b/src/read_dump.cpp @@ -503,7 +503,7 @@ void ReadDump::header(int fieldinfo) yhi = box[1][1]; zlo = box[2][0]; zhi = box[2][1]; - + if (triclinic_snap) { xy = box[0][2]; xz = box[1][2]; diff --git a/src/reader_native.cpp b/src/reader_native.cpp index a4b188be5f..da2c97bbe5 100644 --- a/src/reader_native.cpp +++ b/src/reader_native.cpp @@ -113,7 +113,7 @@ void ReaderNative::skip() only called by proc 0 ------------------------------------------------------------------------- */ -bigint ReaderNative::read_header(double box[3][3], int &boxinfo, 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, From d64bc2a1b791c149bbc59ed4c908aa6bbea511dd Mon Sep 17 00:00:00 2001 From: julient31 Date: Mon, 4 Nov 2019 08:05:07 -0700 Subject: [PATCH 335/557] Commit JT 110419 - commit changes examples --- examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp | 6 +++--- examples/SPIN/iron/in.spin.iron | 5 +++-- 2 files changed, 6 insertions(+), 5 deletions(-) diff --git a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp index b9ede5f09c..8ea82a509b 100644 --- a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp +++ b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp @@ -25,8 +25,8 @@ velocity all create 100 4928459 rot yes dist gaussian #pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy ../examples/SPIN/cobalt_hcp/Co_PurjaPun_2012.eam.alloy Co -#pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +# pair_coeff * * eam/alloy ../examples/SPIN/cobalt_hcp/Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co pair_coeff * * spin/exchange exchange 4.0 -0.3593 1.135028015e-05 1.064568567 #pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 @@ -52,7 +52,7 @@ variable magnorm equal c_out_mag[4] variable emag equal c_out_mag[5] variable tmag equal c_out_mag[6] -thermo_style custom step time v_magnorm v_emag temp etotal +thermo_style custom step time v_magnorm v_emag temp press etotal thermo 10 compute outsp all property/atom spx spy spz sp fmx fmy fmz diff --git a/examples/SPIN/iron/in.spin.iron b/examples/SPIN/iron/in.spin.iron index 3468575493..fd504d2cfd 100644 --- a/examples/SPIN/iron/in.spin.iron +++ b/examples/SPIN/iron/in.spin.iron @@ -48,10 +48,11 @@ variable magnorm equal c_out_mag[4] variable emag equal c_out_mag[5] variable tmag equal c_out_mag[6] -thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe etotal +thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe press etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +# dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_iron.lammpstrj type x y z fx fy fz run 50000 From 1074884f741c20ac7b5c5b1459bbc4dbfba18ea3 Mon Sep 17 00:00:00 2001 From: julient31 Date: Mon, 4 Nov 2019 09:04:43 -0700 Subject: [PATCH 336/557] Commit JT 110419 - removed fmax uninitialized variable from min_cg.cpp - removed tabs from comments - initialized fdotf variables --- src/SPIN/min_spin.cpp | 6 +++--- src/SPIN/min_spin_cg.cpp | 6 +++--- src/SPIN/min_spin_lbfgs.cpp | 6 +++--- src/min_cg.cpp | 21 +++++++++------------ src/min_fire.cpp | 7 ++++--- src/min_quickmin.cpp | 7 ++++--- src/min_sd.cpp | 13 ++++++++----- 7 files changed, 34 insertions(+), 32 deletions(-) diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 7315aca056..e39eb18744 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -165,9 +165,9 @@ int MinSpin::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { diff --git a/src/SPIN/min_spin_cg.cpp b/src/SPIN/min_spin_cg.cpp index 95bbcf437b..d8238c9aee 100644 --- a/src/SPIN/min_spin_cg.cpp +++ b/src/SPIN/min_spin_cg.cpp @@ -270,9 +270,9 @@ int MinSpinCG::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { diff --git a/src/SPIN/min_spin_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp index f86bdd5d48..2c7e658419 100644 --- a/src/SPIN/min_spin_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -285,9 +285,9 @@ int MinSpinLBFGS::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { diff --git a/src/min_cg.cpp b/src/min_cg.cpp index 80dde25f51..4cf53f08bc 100644 --- a/src/min_cg.cpp +++ b/src/min_cg.cpp @@ -36,7 +36,7 @@ MinCG::MinCG(LAMMPS *lmp) : MinLineSearch(lmp) {} int MinCG::iterate(int maxiter) { int i,m,n,fail,ntimestep; - double beta,gg,dot[2],dotall[2],fmax; + double beta,gg,dot[2],dotall[2],fdotf; double *fatom,*gatom,*hatom; // nlimit = max # of CG iterations before restarting @@ -100,7 +100,6 @@ int MinCG::iterate(int maxiter) for (i = 0; i < n; i++) { dot[0] += fatom[i]*fatom[i]; dot[1] += fatom[i]*gatom[i]; - fmax = MAX(fmax,fatom[i]*fatom[i]); } } MPI_Allreduce(dot,dotall,2,MPI_DOUBLE,MPI_SUM,world); @@ -110,16 +109,14 @@ int MinCG::iterate(int maxiter) dotall[1] += fextra[i]*gextra[i]; } - fmax = 0.0; - if (normstyle == MAX) { // max force norm - fmax = fnorm_max(); - if (fmax < update->ftol*update->ftol) return FTOL; - } else if (normstyle == INF) { // infinite force norm - fmax = fnorm_inf(); - if (fmax < update->ftol*update->ftol) return FTOL; - } else if (normstyle == TWO) { // Euclidean force 2-norm - if (dotall[0] < update->ftol*update->ftol) return FTOL; - } else error->all(FLERR,"Illegal min_modify command"); + fdotf = 0.0; + if (update->ftol > 0.0) { + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // infinite force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + else error->all(FLERR,"Illegal min_modify command"); + if (fdotf < update->ftol*update->ftol) return FTOL; + } // update new search direction h from new f = -Grad(x) and old g // this is Polak-Ribieri formulation diff --git a/src/min_fire.cpp b/src/min_fire.cpp index b4b0f14534..ca37e410b8 100644 --- a/src/min_fire.cpp +++ b/src/min_fire.cpp @@ -250,10 +250,11 @@ int MinFire::iterate(int maxiter) // force tolerance criterion // sync across replicas if running multi-replica minimization + fdotf = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fdotf = fnorm_max(); // max force norm - else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm - else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm else error->all(FLERR,"Illegal min_modify command"); if (update->multireplica == 0) { if (fdotf < update->ftol*update->ftol) return FTOL; diff --git a/src/min_quickmin.cpp b/src/min_quickmin.cpp index 5f3728153a..5e7643bf3b 100644 --- a/src/min_quickmin.cpp +++ b/src/min_quickmin.cpp @@ -215,10 +215,11 @@ int MinQuickMin::iterate(int maxiter) // force tolerance criterion // sync across replicas if running multi-replica minimization + fdotf = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fdotf = fnorm_max(); // max force norm - else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm - else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // inf force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm else error->all(FLERR,"Illegal min_modify command"); if (update->multireplica == 0) { if (fdotf < update->ftol*update->ftol) return FTOL; diff --git a/src/min_sd.cpp b/src/min_sd.cpp index 627a3b3cf3..d973ec1c82 100644 --- a/src/min_sd.cpp +++ b/src/min_sd.cpp @@ -78,11 +78,14 @@ int MinSD::iterate(int maxiter) // force tolerance criterion - if (normstyle == MAX) fdotf = fnorm_max(); // max force norm - else if (normstyle == INF) fdotf = fnorm_inf(); // infinite force norm - else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm - else error->all(FLERR,"Illegal min_modify command"); - if (fdotf < update->ftol*update->ftol) return FTOL; + fdotf = 0.0; + if (update->ftol > 0.0) { + if (normstyle == MAX) fdotf = fnorm_max(); // max force norm + else if (normstyle == INF) fdotf = fnorm_inf(); // infinite force norm + else if (normstyle == TWO) fdotf = fnorm_sqr(); // Euclidean force 2-norm + else error->all(FLERR,"Illegal min_modify command"); + if (fdotf < update->ftol*update->ftol) return FTOL; + } // set new search direction h to f = -Grad(x) From 74e502eb637762f8d07d43eccfc7a1564aef68c7 Mon Sep 17 00:00:00 2001 From: julient31 Date: Mon, 4 Nov 2019 09:59:37 -0700 Subject: [PATCH 337/557] Commit2 JT 110419 - removed all tabs from spin package --- src/SPIN/atom_vec_spin.h | 12 ++-- src/SPIN/fix_neb_spin.h | 24 +++---- src/SPIN/fix_nve_spin.cpp | 8 +-- src/SPIN/fix_nve_spin.h | 36 +++++----- src/SPIN/fix_precession_spin.cpp | 14 ++-- src/SPIN/fix_precession_spin.h | 14 ++-- src/SPIN/min_spin.cpp | 6 +- src/SPIN/min_spin_cg.cpp | 12 ++-- src/SPIN/min_spin_cg.h | 30 ++++----- src/SPIN/min_spin_lbfgs.cpp | 8 +-- src/SPIN/min_spin_lbfgs.h | 32 ++++----- src/SPIN/neb_spin.cpp | 108 +++++++++++++++--------------- src/SPIN/pair_spin.h | 4 +- src/SPIN/pair_spin_dipole_cut.cpp | 42 ++++++------ src/SPIN/pair_spin_dipole_cut.h | 14 ++-- src/SPIN/pair_spin_dipole_long.h | 14 ++-- src/SPIN/pair_spin_dmi.h | 10 +-- src/SPIN/pair_spin_exchange.h | 8 +-- src/SPIN/pair_spin_magelec.h | 8 +-- src/SPIN/pair_spin_neel.h | 12 ++-- 20 files changed, 208 insertions(+), 208 deletions(-) diff --git a/src/SPIN/atom_vec_spin.h b/src/SPIN/atom_vec_spin.h index 1f1c34df52..a31e57bb48 100644 --- a/src/SPIN/atom_vec_spin.h +++ b/src/SPIN/atom_vec_spin.h @@ -67,13 +67,13 @@ class AtomVecSpin : public AtomVec { tagint *tag; int *type,*mask; imageint *image; - double **x,**v,**f; // lattice quantities + double **x,**v,**f; // lattice quantities - // spin quantities - double **sp; // sp[i][0-2] direction of the spin i - // sp[i][3] atomic magnetic moment of the spin i - double **fm; // fm[i][0-2] direction of magnetic precession - double **fm_long; // storage of long-range spin prec. components + // spin quantities + double **sp; // sp[i][0-2] direction of the spin i + // sp[i][3] atomic magnetic moment of the spin i + double **fm; // fm[i][0-2] direction of magnetic precession + double **fm_long; // storage of long-range spin prec. components }; } diff --git a/src/SPIN/fix_neb_spin.h b/src/SPIN/fix_neb_spin.h index 7ac83ddce7..9646684a3a 100644 --- a/src/SPIN/fix_neb_spin.h +++ b/src/SPIN/fix_neb_spin.h @@ -60,20 +60,20 @@ class FixNEBSpin : public Fix { double **spprev,**spnext,**fmnext; double **springF; double **tangent; - double **xsend,**xrecv; // coords to send/recv to/from other replica - double **fsend,**frecv; // coords to send/recv to/from other replica - double **spsend,**sprecv; // sp to send/recv to/from other replica - double **fmsend,**fmrecv; // fm to send/recv to/from other replica - tagint *tagsend,*tagrecv; // ditto for atom IDs + double **xsend,**xrecv; // coords to send/recv to/from other replica + double **fsend,**frecv; // coords to send/recv to/from other replica + double **spsend,**sprecv; // sp to send/recv to/from other replica + double **fmsend,**fmrecv; // fm to send/recv to/from other replica + tagint *tagsend,*tagrecv; // ditto for atom IDs - // info gathered from all procs in my replica - double **xsendall,**xrecvall; // coords to send/recv to/from other replica - double **fsendall,**frecvall; // force to send/recv to/from other replica - double **spsendall,**sprecvall; // sp to send/recv to/from other replica - double **fmsendall,**fmrecvall; // fm to send/recv to/from other replica - tagint *tagsendall,*tagrecvall; // ditto for atom IDs + // info gathered from all procs in my replica + double **xsendall,**xrecvall; // coords to send/recv to/from other replica + double **fsendall,**frecvall; // force to send/recv to/from other replica + double **spsendall,**sprecvall; // sp to send/recv to/from other replica + double **fmsendall,**fmrecvall; // fm to send/recv to/from other replica + tagint *tagsendall,*tagrecvall; // ditto for atom IDs - int *counts,*displacements; // used for MPI_Gather + int *counts,*displacements; // used for MPI_Gather double geodesic_distance(double *, double *); void inter_replica_comm(); diff --git a/src/SPIN/fix_nve_spin.cpp b/src/SPIN/fix_nve_spin.cpp index 9b4f1916ae..87546ba9da 100644 --- a/src/SPIN/fix_nve_spin.cpp +++ b/src/SPIN/fix_nve_spin.cpp @@ -307,7 +307,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = forward_stacks[i]; - } + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal @@ -318,7 +318,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = backward_stacks[i]; - } + } } } } else if (sector_flag == 0) { // serial seq. update @@ -360,7 +360,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = forward_stacks[i]; - } + } } } for (int j = nsectors-1; j >= 0; j--) { // advance quarter s for nlocal @@ -371,7 +371,7 @@ void FixNVESpin::initial_integrate(int /*vflag*/) ComputeInteractionsSpin(i); AdvanceSingleSpin(i); i = backward_stacks[i]; - } + } } } } else if (sector_flag == 0) { // serial seq. update diff --git a/src/SPIN/fix_nve_spin.h b/src/SPIN/fix_nve_spin.h index 5871f721be..5aa6b8e4e4 100644 --- a/src/SPIN/fix_nve_spin.h +++ b/src/SPIN/fix_nve_spin.h @@ -34,30 +34,30 @@ friend class PairSpin; virtual void initial_integrate(int); virtual void final_integrate(); - void ComputeInteractionsSpin(int); // compute and advance single spin functions + void ComputeInteractionsSpin(int); // compute and advance single spin functions void AdvanceSingleSpin(int); - void sectoring(); // sectoring operation functions + void sectoring(); // sectoring operation functions int coords2sector(double *); void setup_pre_neighbor(); void pre_neighbor(); - int lattice_flag; // lattice_flag = 0 if spins only - // lattice_flag = 1 if spin-lattice calc. + int lattice_flag; // lattice_flag = 0 if spins only + // lattice_flag = 1 if spin-lattice calc. protected: - int sector_flag; // sector_flag = 0 if serial algorithm - // sector_flag = 1 if parallel algorithm + int sector_flag; // sector_flag = 0 if serial algorithm + // sector_flag = 1 if parallel algorithm - double dtv, dtf, dts; // velocity, force, and spin timesteps + double dtv, dtf, dts; // velocity, force, and spin timesteps - int nlocal_max; // max value of nlocal (for size of lists) + int nlocal_max; // max value of nlocal (for size of lists) - int pair_spin_flag; // magnetic pair flags - int long_spin_flag; // magnetic long-range flag - int precession_spin_flag; // magnetic precession flags - int maglangevin_flag; // magnetic langevin flags + int pair_spin_flag; // magnetic pair flags + int long_spin_flag; // magnetic long-range flag + int precession_spin_flag; // magnetic precession flags + int maglangevin_flag; // magnetic langevin flags int tdamp_flag, temp_flag; int setforce_spin_flag; @@ -69,9 +69,9 @@ friend class PairSpin; // pointers to magnetic pair styles - int npairs, npairspin; // # of pairs, and # of spin pairs + int npairs, npairspin; // # of pairs, and # of spin pairs class Pair *pair; - class PairSpin **spin_pairs; // vector of spin pairs + class PairSpin **spin_pairs; // vector of spin pairs // sectoring variables @@ -80,10 +80,10 @@ friend class PairSpin; // stacking variables for sectoring algorithm - int *stack_head; // index of first atom in backward_stacks - int *stack_foot; // index of first atom in forward_stacks - int *backward_stacks; // index of next atom in backward stack - int *forward_stacks; // index of next atom in forward stack + int *stack_head; // index of first atom in backward_stacks + int *stack_foot; // index of first atom in forward_stacks + int *backward_stacks; // index of next atom in backward stack + int *forward_stacks; // index of next atom in forward stack }; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 3b8817704d..4294e5361a 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -173,9 +173,9 @@ int FixPrecessionSpin::setmask() void FixPrecessionSpin::init() { - const double hbar = force->hplanck/MY_2PI; // eV/(rad.THz) - const double mub = 5.78901e-5; // in eV/T - const double gyro = 2.0*mub/hbar; // in rad.THz/T + const double hbar = force->hplanck/MY_2PI; // eV/(rad.THz) + const double mub = 5.78901e-5; // in eV/T + const double gyro = 2.0*mub/hbar; // in rad.THz/T // convert field quantities to rad.THz @@ -236,7 +236,7 @@ void FixPrecessionSpin::post_force(int /* vflag */) if (varflag != CONSTANT) { modify->clearstep_compute(); modify->addstep_compute(update->ntimestep + 1); - set_magneticprecession(); // update mag. field if time-dep. + set_magneticprecession(); // update mag. field if time-dep. } int *mask = atom->mask; @@ -266,9 +266,9 @@ void FixPrecessionSpin::post_force(int /* vflag */) epreci -= compute_anisotropy_energy(spi); } - if (cubic_flag) { // compute cubic anisotropy - compute_cubic(spi,fmi); - epreci -= compute_cubic_energy(spi); + if (cubic_flag) { // compute cubic anisotropy + compute_cubic(spi,fmi); + epreci -= compute_cubic_energy(spi); } eprec += epreci; diff --git a/src/SPIN/fix_precession_spin.h b/src/SPIN/fix_precession_spin.h index 0037784a48..96d89e004e 100644 --- a/src/SPIN/fix_precession_spin.h +++ b/src/SPIN/fix_precession_spin.h @@ -54,7 +54,7 @@ class FixPrecessionSpin : public Fix { double compute_cubic_energy(double *); protected: - int style; // style of the magnetic precession + int style; // style of the magnetic precession double degree2rad; double hbar; @@ -72,19 +72,19 @@ class FixPrecessionSpin : public Fix { double H_field; double nhx, nhy, nhz; - double hx, hy, hz; // temp. force variables + double hx, hy, hz; // temp. force variables // magnetic anisotropy intensity and direction - double Ka; // aniso const. in eV - double Kah; // aniso const. in rad.THz + double Ka; // aniso const. in eV + double Kah; // aniso const. in rad.THz double nax, nay, naz; - double Kax, Kay, Kaz; // temp. force variables + double Kax, Kay, Kaz; // temp. force variables // cubic anisotropy intensity - double k1c,k2c; // cubic const. in eV - double k1ch,k2ch; // cubic const. in rad.THz + double k1c,k2c; // cubic const. in eV + double k1ch,k2ch; // cubic const. in rad.THz double nc1x,nc1y,nc1z; double nc2x,nc2y,nc2z; double nc3x,nc3y,nc3z; diff --git a/src/SPIN/min_spin.cpp b/src/SPIN/min_spin.cpp index 7315aca056..e39eb18744 100644 --- a/src/SPIN/min_spin.cpp +++ b/src/SPIN/min_spin.cpp @@ -165,9 +165,9 @@ int MinSpin::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { diff --git a/src/SPIN/min_spin_cg.cpp b/src/SPIN/min_spin_cg.cpp index 95bbcf437b..9c8c814bc4 100644 --- a/src/SPIN/min_spin_cg.cpp +++ b/src/SPIN/min_spin_cg.cpp @@ -270,9 +270,9 @@ int MinSpinCG::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { @@ -347,12 +347,12 @@ void MinSpinCG::calc_search_direction() factor = 0.0; - if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction + if (local_iter == 0 || local_iter % 5 == 0){ // steepest descent direction for (int i = 0; i < 3 * nlocal; i++) { p_s[i] = -g_cur[i] * factor; g_old[i] = g_cur[i] * factor; } - } else { // conjugate direction + } else { // conjugate direction for (int i = 0; i < 3 * nlocal; i++) { g2old += g_old[i] * g_old[i]; g2 += g_cur[i] * g_cur[i]; @@ -394,7 +394,7 @@ void MinSpinCG::advance_spins() { int nlocal = atom->nlocal; double **sp = atom->sp; - double rot_mat[9]; // exponential of matrix made of search direction + double rot_mat[9]; // exponential of matrix made of search direction double s_new[3]; // loop on all spins on proc. diff --git a/src/SPIN/min_spin_cg.h b/src/SPIN/min_spin_cg.h index 0eed7a61e6..640721b8ef 100644 --- a/src/SPIN/min_spin_cg.h +++ b/src/SPIN/min_spin_cg.h @@ -35,21 +35,21 @@ class MinSpinCG: public Min { int iterate(int); private: - int local_iter; // for neb - int nlocal_max; // max value of nlocal (for size of lists) - int use_line_search; // use line search or not. - int ireplica,nreplica; // for neb - double dt; // global timestep - double dts; // spin timestep - double discrete_factor; // factor for spin timestep evaluation - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector - double **sp_copy; // copy of the spins + int local_iter; // for neb + int nlocal_max; // max value of nlocal (for size of lists) + int use_line_search; // use line search or not. + int ireplica,nreplica; // for neb + double dt; // global timestep + double dts; // spin timestep + double discrete_factor; // factor for spin timestep evaluation + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector + double **sp_copy; // copy of the spins void advance_spins(); void calc_gradient(); diff --git a/src/SPIN/min_spin_lbfgs.cpp b/src/SPIN/min_spin_lbfgs.cpp index f86bdd5d48..a1ee010f3f 100644 --- a/src/SPIN/min_spin_lbfgs.cpp +++ b/src/SPIN/min_spin_lbfgs.cpp @@ -285,9 +285,9 @@ int MinSpinLBFGS::iterate(int maxiter) fmdotfm = fmsq = 0.0; if (update->ftol > 0.0) { - if (normstyle == MAX) fmsq = max_torque(); // max torque norm - else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm - else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm + if (normstyle == MAX) fmsq = max_torque(); // max torque norm + else if (normstyle == INF) fmsq = inf_torque(); // inf torque norm + else if (normstyle == TWO) fmsq = total_torque(); // Euclidean torque 2-norm else error->all(FLERR,"Illegal min_modify command"); fmdotfm = fmsq*fmsq; if (update->multireplica == 0) { @@ -372,7 +372,7 @@ void MinSpinLBFGS::calc_search_direction() factor = 1.0; } - if (local_iter == 0){ // steepest descent direction + if (local_iter == 0){ // steepest descent direction //if no line search then calculate maximum rotation if (use_line_search == 0) diff --git a/src/SPIN/min_spin_lbfgs.h b/src/SPIN/min_spin_lbfgs.h index cead605b32..8b470b5d23 100644 --- a/src/SPIN/min_spin_lbfgs.h +++ b/src/SPIN/min_spin_lbfgs.h @@ -35,18 +35,18 @@ class MinSpinLBFGS: public Min { int iterate(int); private: - int local_iter; // for neb - int use_line_search; // use line search or not. - int nlocal_max; // max value of nlocal (for size of lists) - int ireplica,nreplica; // for neb - double der_e_cur; // current derivative along search dir. - double der_e_pr; // previous derivative along search dir. + int local_iter; // for neb + int use_line_search; // use line search or not. + int nlocal_max; // max value of nlocal (for size of lists) + int ireplica,nreplica; // for neb + double der_e_cur; // current derivative along search dir. + double der_e_pr; // previous derivative along search dir. double maxepsrot; - double *spvec; // variables for atomic dof, as 1d vector - double *fmvec; // variables for atomic dof, as 1d vector - double *g_old; // gradient vector at previous step - double *g_cur; // current gradient vector - double *p_s; // search direction vector + double *spvec; // variables for atomic dof, as 1d vector + double *fmvec; // variables for atomic dof, as 1d vector + double *g_old; // gradient vector at previous step + double *g_cur; // current gradient vector + double *p_s; // search direction vector void advance_spins(); void calc_gradient(); @@ -58,11 +58,11 @@ class MinSpinLBFGS: public Min { int adescent(double, double); double maximum_rotation(double *); - double *rho; // estimation of curvature - double **ds; // change in rotation matrix between two iterations, da - double **dy; // change in gradients between two iterations, dg - double **sp_copy; // copy of the spins - int num_mem; // number of stored steps + double *rho; // estimation of curvature + double **ds; // change in rotation matrix between two iterations, da + double **dy; // change in gradients between two iterations, dg + double **sp_copy; // copy of the spins + int num_mem; // number of stored steps bigint last_negative; }; diff --git a/src/SPIN/neb_spin.cpp b/src/SPIN/neb_spin.cpp index 559fd1cb49..075850d1af 100644 --- a/src/SPIN/neb_spin.cpp +++ b/src/SPIN/neb_spin.cpp @@ -179,7 +179,7 @@ void NEBSpin::run() update->whichflag = 2; update->etol = etol; - update->ftol = ttol; // update->ftol is a torque tolerance + update->ftol = ttol; // update->ftol is a torque tolerance update->multireplica = 1; lmp->init(); @@ -214,7 +214,7 @@ void NEBSpin::run() fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT " "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT RD1 PE1 RD2 PE2 ... " @@ -224,10 +224,10 @@ void NEBSpin::run() if (ulogfile) { if (verbose) { - fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " - "GradV0 GradV1 GradVc EBF EBR RDT " - "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " + "GradV0 GradV1 GradVc EBF EBR RDT " + "RD1 PE1 RD2 PE2 ... RDN PEN " + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT RD1 PE1 RD2 PE2 ... " @@ -301,7 +301,7 @@ void NEBSpin::run() fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc EBF EBR RDT " "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0... GradVNdottan DNN\n"); + "GradV0dottan DN0... GradVNdottan DNN\n"); } else { fprintf(uscreen,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc " @@ -311,10 +311,10 @@ void NEBSpin::run() } if (ulogfile) { if (verbose) { - fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " - "GradV0 GradV1 GradVc EBF EBR RDT " - "RD1 PE1 RD2 PE2 ... RDN PEN " - "GradV0dottan DN0 ... GradVNdottan DNN\n"); + fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " + "GradV0 GradV1 GradVc EBF EBR RDT " + "RD1 PE1 RD2 PE2 ... RDN PEN " + "GradV0dottan DN0 ... GradVNdottan DNN\n"); } else { fprintf(ulogfile,"Step MaxReplicaTorque MaxAtomTorque " "GradV0 GradV1 GradVc " @@ -472,8 +472,8 @@ void NEBSpin::readfile(char *file, int flag) m = atom->map(tag); if (m >= 0 && m < nlocal) { ncount++; - musp = atof(values[1]); - xx = atof(values[2]); + musp = atof(values[1]); + xx = atof(values[2]); yy = atof(values[3]); zz = atof(values[4]); spx = atof(values[5]); @@ -482,39 +482,39 @@ void NEBSpin::readfile(char *file, int flag) if (flag == 0) { - spinit[0] = sp[m][0]; - spinit[1] = sp[m][1]; - spinit[2] = sp[m][2]; - spfinal[0] = spx; - spfinal[1] = spy; - spfinal[2] = spz; + spinit[0] = sp[m][0]; + spinit[1] = sp[m][1]; + spinit[2] = sp[m][2]; + spfinal[0] = spx; + spfinal[1] = spy; + spfinal[2] = spz; - // interpolate intermediate spin states + // interpolate intermediate spin states - sp[m][3] = musp; - if (fraction == 0.0) { - sp[m][0] = spinit[0]; - sp[m][1] = spinit[1]; - sp[m][2] = spinit[2]; - } else if (fraction == 1.0) { - sp[m][0] = spfinal[0]; - sp[m][1] = spfinal[1]; - sp[m][2] = spfinal[2]; - } else { + sp[m][3] = musp; + if (fraction == 0.0) { + sp[m][0] = spinit[0]; + sp[m][1] = spinit[1]; + sp[m][2] = spinit[2]; + } else if (fraction == 1.0) { + sp[m][0] = spfinal[0]; + sp[m][1] = spfinal[1]; + sp[m][2] = spfinal[2]; + } else { temp_flag = initial_rotation(spinit,spfinal,fraction); rot_flag = MAX(temp_flag,rot_flag); - sp[m][0] = spfinal[0]; - sp[m][1] = spfinal[1]; - sp[m][2] = spfinal[2]; - } + sp[m][0] = spfinal[0]; + sp[m][1] = spfinal[1]; + sp[m][2] = spfinal[2]; + } } else { sp[m][3] = musp; - x[m][0] = xx; + x[m][0] = xx; x[m][1] = yy; x[m][2] = zz; - sp[m][0] = spx; - sp[m][1] = spy; - sp[m][2] = spz; + sp[m][0] = spx; + sp[m][1] = spy; + sp[m][2] = spz; } } @@ -602,24 +602,24 @@ int NEBSpin::initial_rotation(double *spi, double *sploc, double fraction) // Rodrigues' formula breaks, needs to define another axis k if (knormsq == 0.0) { - if (sidotsf > 0.0) { // spins aligned and in same direction + if (sidotsf > 0.0) { // spins aligned and in same direction return 0; - } else if (sidotsf < 0.0) { // spins aligned and in opposite directions + } else if (sidotsf < 0.0) { // spins aligned and in opposite directions // defining a rotation axis // first guess, k = spi x [100] // second guess, k = spi x [010] if (spiy*spiy + spiz*spiz != 0.0) { // spin not along [100] - kx = 0.0; - ky = spiz; - kz = -spiy; - knormsq = ky*ky + kz*kz; + kx = 0.0; + ky = spiz; + kz = -spiy; + knormsq = ky*ky + kz*kz; } else if (spix*spix + spiz*spiz != 0.0) { // spin not along [010] - kx = -spiz; - ky = 0.0; - kz = spix; - knormsq = kx*kx + kz*kz; + kx = -spiz; + ky = 0.0; + kz = spix; + knormsq = kx*kx + kz*kz; } else error->all(FLERR,"Incorrect initial rotation operation"); rot_flag = 1; } @@ -822,9 +822,9 @@ void NEBSpin::print_status() for (int i = 0; i < nreplica; i++) fprintf(uscreen,"%12.8g %12.8g ",rdist[i],all[i][0]); if (verbose) { - for (int i = 0; i < nreplica-1; i++) - fprintf(uscreen,"%12.8g %12.8g ",all[i][2],all[i][5]); - fprintf(uscreen,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); + for (int i = 0; i < nreplica-1; i++) + fprintf(uscreen,"%12.8g %12.8g ",all[i][2],all[i][5]); + fprintf(uscreen,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); } fprintf(uscreen,"\n"); } @@ -838,9 +838,9 @@ void NEBSpin::print_status() for (int i = 0; i < nreplica; i++) fprintf(ulogfile,"%12.8g %12.8g ",rdist[i],all[i][0]); if (verbose) { - for (int i = 0; i < nreplica-1; i++) - fprintf(ulogfile,"%12.8g %12.8g ",all[i][2],all[i][5]); - fprintf(ulogfile,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); + for (int i = 0; i < nreplica-1; i++) + fprintf(ulogfile,"%12.8g %12.8g ",all[i][2],all[i][5]); + fprintf(ulogfile,"%12.8g %12.8g ",NAN,all[nreplica-1][5]); } fprintf(ulogfile,"\n"); fflush(ulogfile); diff --git a/src/SPIN/pair_spin.h b/src/SPIN/pair_spin.h index 0111814c72..34f12d8d59 100644 --- a/src/SPIN/pair_spin.h +++ b/src/SPIN/pair_spin.h @@ -33,8 +33,8 @@ friend class FixNVESpin; virtual void compute_single_pair(int, double *) {} protected: - double hbar; // Planck constant (eV.ps.rad-1) - int lattice_flag; // flag for mech force computation + double hbar; // Planck constant (eV.ps.rad-1) + int lattice_flag; // flag for mech force computation virtual void allocate() {} }; diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index 4ff90323f2..bae09689de 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -46,11 +46,11 @@ PairSpinDipoleCut::PairSpinDipoleCut(LAMMPS *lmp) : PairSpin(lmp) { spinflag = 1; - 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 + //mub2mu0 = mub * mub * mu_0 / (4.0*MY_PI); // in eV mub2mu0hbinv = mub2mu0 / hbar; // in rad.THz } @@ -178,7 +178,7 @@ void PairSpinDipoleCut::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; inum = list->inum; ilist = list->ilist; @@ -228,36 +228,36 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) if (rsq < local_cut2) { r2inv = 1.0/rsq; - r3inv = r2inv*rinv; - - compute_dipolar(i,j,eij,fmi,spi,spj,r3inv); - if (lattice_flag) compute_dipolar_mech(i,j,eij,fi,spi,spj,r2inv); + r3inv = r2inv*rinv; + + compute_dipolar(i,j,eij,fmi,spi,spj,r3inv); + if (lattice_flag) compute_dipolar_mech(i,j,eij,fi,spi,spj,r2inv); } // force accumulation f[i][0] += fi[0]; - f[i][1] += fi[1]; + f[i][1] += fi[1]; f[i][2] += fi[2]; 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]); } } @@ -277,7 +277,7 @@ void PairSpinDipoleCut::compute_single_pair(int ii, double fmi[3]) int k,locflag; int *type = atom->type; double **x = atom->x; - double **sp = atom->sp; + double **sp = atom->sp; numneigh = list->numneigh; firstneigh = list->firstneigh; @@ -427,7 +427,7 @@ void PairSpinDipoleCut::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); } } } @@ -450,10 +450,10 @@ void PairSpinDipoleCut::read_restart(FILE *fp) if (me == 0) utils::sfread(FLERR,&setflag[i][j],sizeof(int),1,fp,NULL,error); MPI_Bcast(&setflag[i][j],1,MPI_INT,0,world); if (setflag[i][j]) { - if (me == 0) { - utils::sfread(FLERR,&cut_spin_long[i][j],sizeof(int),1,fp,NULL,error); - } - MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); + if (me == 0) { + utils::sfread(FLERR,&cut_spin_long[i][j],sizeof(int),1,fp,NULL,error); + } + MPI_Bcast(&cut_spin_long[i][j],1,MPI_INT,0,world); } } } diff --git a/src/SPIN/pair_spin_dipole_cut.h b/src/SPIN/pair_spin_dipole_cut.h index f9159a629f..33f62d1633 100644 --- a/src/SPIN/pair_spin_dipole_cut.h +++ b/src/SPIN/pair_spin_dipole_cut.h @@ -49,16 +49,16 @@ class PairSpinDipoleCut : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_long_global; // global long cutoff distance + double cut_spin_long_global; // global long cutoff distance protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton - double mu_0; // vacuum permeability - double mub2mu0; // prefactor for mech force - double mub2mu0hbinv; // prefactor for mag force + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton + double mu_0; // vacuum permeability + double mub2mu0; // prefactor for mech force + double mub2mu0hbinv; // prefactor for mag force - double **cut_spin_long; // cutoff distance long + double **cut_spin_long; // cutoff distance long double g_ewald; int ewald_order; diff --git a/src/SPIN/pair_spin_dipole_long.h b/src/SPIN/pair_spin_dipole_long.h index 1997cbbc55..56fd4c7126 100644 --- a/src/SPIN/pair_spin_dipole_long.h +++ b/src/SPIN/pair_spin_dipole_long.h @@ -50,16 +50,16 @@ class PairSpinDipoleLong : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_long_global; // global long cutoff distance + double cut_spin_long_global; // global long cutoff distance protected: - double hbar; // reduced Planck's constant - double mub; // Bohr's magneton - double mu_0; // vacuum permeability - double mub2mu0; // prefactor for mech force - double mub2mu0hbinv; // prefactor for mag force + double hbar; // reduced Planck's constant + double mub; // Bohr's magneton + double mu_0; // vacuum permeability + double mub2mu0; // prefactor for mech force + double mub2mu0hbinv; // prefactor for mag force - double **cut_spin_long; // cutoff distance long + double **cut_spin_long; // cutoff distance long double g_ewald; int ewald_order; diff --git a/src/SPIN/pair_spin_dmi.h b/src/SPIN/pair_spin_dmi.h index ac2aa387b3..01022623ec 100644 --- a/src/SPIN/pair_spin_dmi.h +++ b/src/SPIN/pair_spin_dmi.h @@ -44,13 +44,13 @@ class PairSpinDmi : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_dmi_global; // short range pair cutoff + double cut_spin_dmi_global; // short range pair cutoff protected: - double **DM; // dmi coeff in eV - double **v_dmx, **v_dmy, **v_dmz; // dmi direction - double **vmech_dmx, **vmech_dmy, **vmech_dmz; // dmi mech direction - double **cut_spin_dmi; // cutoff distance dmi + double **DM; // dmi coeff in eV + double **v_dmx, **v_dmy, **v_dmz; // dmi direction + double **vmech_dmx, **vmech_dmy, **vmech_dmz; // dmi mech direction + double **cut_spin_dmi; // cutoff distance dmi void allocate(); }; diff --git a/src/SPIN/pair_spin_exchange.h b/src/SPIN/pair_spin_exchange.h index 5feb99210f..19eafeb5ca 100644 --- a/src/SPIN/pair_spin_exchange.h +++ b/src/SPIN/pair_spin_exchange.h @@ -44,13 +44,13 @@ class PairSpinExchange : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_exchange_global; // global exchange cutoff distance + double cut_spin_exchange_global; // global exchange cutoff distance protected: - double **J1_mag; // exchange coeffs in eV - double **J1_mech; // mech exchange coeffs in + double **J1_mag; // exchange coeffs in eV + double **J1_mech; // mech exchange coeffs in double **J2, **J3; // J1 in eV, J2 adim, J3 in Ang - double **cut_spin_exchange; // cutoff distance exchange + double **cut_spin_exchange; // cutoff distance exchange void allocate(); }; diff --git a/src/SPIN/pair_spin_magelec.h b/src/SPIN/pair_spin_magelec.h index b9e820b1d1..4df0078bea 100644 --- a/src/SPIN/pair_spin_magelec.h +++ b/src/SPIN/pair_spin_magelec.h @@ -44,12 +44,12 @@ class PairSpinMagelec : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_magelec_global; // global me cutoff + double cut_spin_magelec_global; // global me cutoff protected: - double **ME, **ME_mech; // magelec coeff in eV - double **v_mex, **v_mey, **v_mez; // magelec direction - double **cut_spin_magelec; // magelec cutoff distance + double **ME, **ME_mech; // magelec coeff in eV + double **v_mex, **v_mey, **v_mez; // magelec direction + double **cut_spin_magelec; // magelec cutoff distance void allocate(); }; diff --git a/src/SPIN/pair_spin_neel.h b/src/SPIN/pair_spin_neel.h index 796d8b53f0..5261a7f746 100644 --- a/src/SPIN/pair_spin_neel.h +++ b/src/SPIN/pair_spin_neel.h @@ -44,17 +44,17 @@ class PairSpinNeel : public PairSpin { void write_restart_settings(FILE *); void read_restart_settings(FILE *); - double cut_spin_neel_global; // global neel cutoff distance + double cut_spin_neel_global; // global neel cutoff distance protected: // pseudo-dipolar and pseudo-quadrupolar coeff. - double **g1, **g1_mech; // neel coeffs gij - double **g2, **g3; // g1 in eV, g2 adim, g3 in Ang - double **q1, **q1_mech; // neel coeffs qij - double **q2, **q3; // q1 in eV, q2 adim, q3 in Ang - double **cut_spin_neel; // cutoff distance exchange + double **g1, **g1_mech; // neel coeffs gij + double **g2, **g3; // g1 in eV, g2 adim, g3 in Ang + double **q1, **q1_mech; // neel coeffs qij + double **q2, **q3; // q1 in eV, q2 adim, q3 in Ang + double **cut_spin_neel; // cutoff distance exchange void allocate(); }; From 816546d008cb2ccf83fb39e27dea4eb811e3b4e2 Mon Sep 17 00:00:00 2001 From: julient31 Date: Mon, 4 Nov 2019 17:38:32 -0700 Subject: [PATCH 338/557] Commit3 JT 110419 - comments in precession --- src/SPIN/compute_spin.cpp | 2 +- src/SPIN/fix_langevin_spin.h | 16 ++++++++-------- src/SPIN/fix_precession_spin.cpp | 2 -- src/SPIN/pair_spin_exchange.cpp | 2 ++ 4 files changed, 11 insertions(+), 11 deletions(-) diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 1f808eb1bd..9cd7f5473e 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -104,7 +104,7 @@ void ComputeSpin::compute_vector() mag[0] += sp[i][0]; mag[1] += sp[i][1]; mag[2] += sp[i][2]; - magenergy -= (sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); + magenergy -= 2.0*(sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); tx = sp[i][1]*fm[i][2]-sp[i][2]*fm[i][1]; ty = sp[i][2]*fm[i][0]-sp[i][0]*fm[i][2]; tz = sp[i][0]*fm[i][1]-sp[i][1]*fm[i][0]; diff --git a/src/SPIN/fix_langevin_spin.h b/src/SPIN/fix_langevin_spin.h index 5358438396..b581b70d34 100644 --- a/src/SPIN/fix_langevin_spin.h +++ b/src/SPIN/fix_langevin_spin.h @@ -32,17 +32,17 @@ class FixLangevinSpin : public Fix { void init(); void setup(int); void post_force_respa(int, int, int); - void add_tdamping(double spi[3], double fmi[3]); // add transverse damping - void add_temperature(double fmi[3]); // add temperature - int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags + void add_tdamping(double spi[3], double fmi[3]); // add transverse damping + void add_temperature(double fmi[3]); // add temperature + int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags protected: double *spi, *fmi; - double alpha_t; // transverse mag. damping - double dts; // magnetic timestep - double temp; // spin bath temperature - double D,sigma; // bath intensity var. - double gil_factor; // gilbert's prefactor + double alpha_t; // transverse mag. damping + double dts; // magnetic timestep + double temp; // spin bath temperature + double D,sigma; // bath intensity var. + double gil_factor; // gilbert's prefactor char *id_temp; class Compute *temperature; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 4294e5361a..3749b68d28 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -240,7 +240,6 @@ void FixPrecessionSpin::post_force(int /* vflag */) } int *mask = atom->mask; - double *emag = atom->emag; double **fm = atom->fm; double **sp = atom->sp; const int nlocal = atom->nlocal; @@ -272,7 +271,6 @@ void FixPrecessionSpin::post_force(int /* vflag */) } eprec += epreci; - emag[i] += epreci; fm[i][0] += fmi[0]; fm[i][1] += fmi[1]; fm[i][2] += fmi[2]; diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index ce5cf325c6..8150a7ab19 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -351,6 +351,8 @@ void PairSpinExchange::compute_exchange(int i, int j, double rsq, double fmi[3], Jex *= (1.0-J2[itype][jtype]*ra); Jex *= exp(-ra); + printf("Exchange : %g %g \n",Jex,Jex*hbar); + fmi[0] += 2.0*Jex*spj[0]; fmi[1] += 2.0*Jex*spj[1]; fmi[2] += 2.0*Jex*spj[2]; From 7ec1dccbe0d9a5f3b6339d1d8c08c34471a6e123 Mon Sep 17 00:00:00 2001 From: marian-code Date: Tue, 5 Nov 2019 14:57:44 +0100 Subject: [PATCH 339/557] wrong cmake option for QUIP QUIP cmake option for specifying library path should be QUIP_LIBRARY not QUIP_LIBRARIES --- doc/rst/Build_extras.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/rst/Build_extras.rst b/doc/rst/Build_extras.rst index 1b5fa1672f..49e3d5c801 100644 --- a/doc/rst/Build_extras.rst +++ b/doc/rst/Build_extras.rst @@ -1254,7 +1254,7 @@ lib/quip/README file for details on how to do this. .. parsed-literal:: - -D QUIP_LIBRARIES=path # path to libquip.a (only needed if a custom location) + -D QUIP_LIBRARY=path # path to libquip.a (only needed if a custom location) CMake will not download and build the QUIP library. But once you have done that, a CMake build of LAMMPS with "-D PKG\_USER-QUIP=yes" should From ae4764e61481aadeb54d2a92a53833dfb8c963a3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 5 Nov 2019 11:03:25 -0500 Subject: [PATCH 340/557] address pair match issue with multiple hybrid substyles in exclusion settings --- src/neighbor.cpp | 30 +++++++++++++++++++++++++++--- src/pair_hybrid.h | 1 + 2 files changed, 28 insertions(+), 3 deletions(-) diff --git a/src/neighbor.cpp b/src/neighbor.cpp index 2c77a13258..05259c86e0 100644 --- a/src/neighbor.cpp +++ b/src/neighbor.cpp @@ -34,6 +34,7 @@ #include "comm.h" #include "force.h" #include "pair.h" +#include "pair_hybrid.h" #include "domain.h" #include "group.h" #include "modify.h" @@ -374,9 +375,32 @@ void Neighbor::init() special_flag[3] = 1; else special_flag[3] = 2; - if (force->kspace || force->pair_match("coul/wolf",0) || - force->pair_match("coul/dsf",0) || force->pair_match("thole",0)) - special_flag[1] = special_flag[2] = special_flag[3] = 2; + // We cannot remove special neighbors with kspace or kspace-like pair styles + // as the exclusion needs to remove the full coulomb and not the damped interaction. + // Special treatment is required for hybrid pair styles since Force::pair_match() + // will only return a non-NULL pointer if there is only one substyle of the kind. + + if (force->kspace) { + special_flag[1] = special_flag[2] = special_flag[3] = 2; + } else { + PairHybrid *ph = reinterpret_cast(force->pair_match("^hybrid",0)); + if (ph) { + int flag=0; + for (int isub=0; isub < ph->nstyles; ++isub) { + if (force->pair_match("coul/wolf",0,isub) + || force->pair_match("coul/dsf",0,isub) + || force->pair_match("thole",0,isub)) + ++flag; + } + if (flag) + special_flag[1] = special_flag[2] = special_flag[3] = 2; + } else { + if (force->pair_match("coul/wolf",0) + || force->pair_match("coul/dsf",0) + || force->pair_match("thole",0)) + special_flag[1] = special_flag[2] = special_flag[3] = 2; + } + } // maxwt = max multiplicative factor on atom indices stored in neigh list diff --git a/src/pair_hybrid.h b/src/pair_hybrid.h index 61e961ddcb..7717d1fd51 100644 --- a/src/pair_hybrid.h +++ b/src/pair_hybrid.h @@ -29,6 +29,7 @@ class PairHybrid : public Pair { friend class FixIntel; friend class FixOMP; friend class Force; + friend class Neighbor; friend class Respa; friend class Info; friend class PairDeprecated; From 74dade3ccb388d36cf10e416a0cc6e6d9070e9ea Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 5 Nov 2019 14:01:48 -0500 Subject: [PATCH 341/557] Change doc folder src -> txt, rst -> src --- doc/Makefile | 25 +++++++++--------- doc/{rst => src}/.gitignore | 0 doc/{rst => src}/Build.rst | 0 doc/{rst => src}/Build_basics.rst | 0 doc/{rst => src}/Build_cmake.rst | 0 doc/{rst => src}/Build_development.rst | 0 doc/{rst => src}/Build_extras.rst | 0 doc/{rst => src}/Build_link.rst | 0 doc/{rst => src}/Build_make.rst | 0 doc/{rst => src}/Build_package.rst | 0 doc/{rst => src}/Build_settings.rst | 0 doc/{rst => src}/Build_windows.rst | 0 doc/{rst => src}/Commands.rst | 0 doc/{rst => src}/Commands_all.rst | 0 doc/{rst => src}/Commands_bond.rst | 0 doc/{rst => src}/Commands_category.rst | 0 doc/{rst => src}/Commands_compute.rst | 0 doc/{rst => src}/Commands_fix.rst | 0 doc/{rst => src}/Commands_input.rst | 0 doc/{rst => src}/Commands_kspace.rst | 0 doc/{rst => src}/Commands_pair.rst | 0 doc/{rst => src}/Commands_parse.rst | 0 doc/{rst => src}/Commands_removed.rst | 0 doc/{rst => src}/Commands_structure.rst | 0 doc/{rst => src}/Errors.rst | 0 doc/{rst => src}/Errors_bugs.rst | 0 doc/{rst => src}/Errors_common.rst | 0 doc/{rst => src}/Errors_messages.rst | 0 doc/{rst => src}/Errors_warnings.rst | 0 doc/{rst => src}/Examples.rst | 0 doc/{rst => src}/Howto.rst | 0 doc/{rst => src}/Howto_2d.rst | 0 doc/{rst => src}/Howto_barostat.rst | 0 doc/{rst => src}/Howto_bash.rst | 0 doc/{rst => src}/Howto_bioFF.rst | 0 doc/{rst => src}/Howto_body.rst | 0 doc/{rst => src}/Howto_chunk.rst | 0 doc/{rst => src}/Howto_client_server.rst | 0 doc/{rst => src}/Howto_coreshell.rst | 0 doc/{rst => src}/Howto_couple.rst | 0 doc/{rst => src}/Howto_diffusion.rst | 0 doc/{rst => src}/Howto_dispersion.rst | 0 doc/{rst => src}/Howto_drude.rst | 0 doc/{rst => src}/Howto_drude2.rst | 0 doc/{rst => src}/Howto_elastic.rst | 0 doc/{rst => src}/Howto_github.rst | 0 doc/{rst => src}/Howto_granular.rst | 0 doc/{rst => src}/Howto_kappa.rst | 0 doc/{rst => src}/Howto_library.rst | 0 doc/{rst => src}/Howto_manifold.rst | 0 doc/{rst => src}/Howto_multiple.rst | 0 doc/{rst => src}/Howto_nemd.rst | 0 doc/{rst => src}/Howto_output.rst | 0 doc/{rst => src}/Howto_polarizable.rst | 0 doc/{rst => src}/Howto_pylammps.rst | 0 doc/{rst => src}/Howto_replica.rst | 0 doc/{rst => src}/Howto_restart.rst | 0 doc/{rst => src}/Howto_spc.rst | 0 doc/{rst => src}/Howto_spherical.rst | 0 doc/{rst => src}/Howto_spins.rst | 0 doc/{rst => src}/Howto_temperature.rst | 0 doc/{rst => src}/Howto_thermostat.rst | 0 doc/{rst => src}/Howto_tip3p.rst | 0 doc/{rst => src}/Howto_tip4p.rst | 0 doc/{rst => src}/Howto_triclinic.rst | 0 doc/{rst => src}/Howto_viscosity.rst | 0 doc/{rst => src}/Howto_viz.rst | 0 doc/{rst => src}/Howto_walls.rst | 0 doc/{rst => src}/Install.rst | 0 doc/{rst => src}/Install_git.rst | 0 doc/{rst => src}/Install_linux.rst | 0 doc/{rst => src}/Install_mac.rst | 0 doc/{rst => src}/Install_patch.rst | 0 doc/{rst => src}/Install_svn.rst | 0 doc/{rst => src}/Install_tarball.rst | 0 doc/{rst => src}/Install_windows.rst | 0 doc/{rst => src}/Intro.rst | 0 doc/{rst => src}/Intro_authors.rst | 0 doc/{rst => src}/Intro_features.rst | 0 doc/{rst => src}/Intro_nonfeatures.rst | 0 doc/{rst => src}/Intro_opensource.rst | 0 doc/{rst => src}/Intro_overview.rst | 0 doc/{rst => src}/Intro_website.rst | 0 doc/{rst => src}/Manual.rst | 0 doc/{rst => src}/Manual_build.rst | 0 doc/{rst => src}/Manual_version.rst | 0 doc/{rst => src}/Modify.rst | 0 doc/{rst => src}/Modify_atom.rst | 0 doc/{rst => src}/Modify_body.rst | 0 doc/{rst => src}/Modify_bond.rst | 0 doc/{rst => src}/Modify_command.rst | 0 doc/{rst => src}/Modify_compute.rst | 0 doc/{rst => src}/Modify_contribute.rst | 0 doc/{rst => src}/Modify_dump.rst | 0 doc/{rst => src}/Modify_fix.rst | 0 doc/{rst => src}/Modify_kspace.rst | 0 doc/{rst => src}/Modify_min.rst | 0 doc/{rst => src}/Modify_overview.rst | 0 doc/{rst => src}/Modify_pair.rst | 0 doc/{rst => src}/Modify_region.rst | 0 doc/{rst => src}/Modify_thermo.rst | 0 doc/{rst => src}/Modify_variable.rst | 0 doc/{rst => src}/Packages.rst | 0 doc/{rst => src}/Packages_details.rst | 0 doc/{rst => src}/Packages_standard.rst | 0 doc/{rst => src}/Packages_user.rst | 0 doc/{rst => src}/Python_call.rst | 0 doc/{rst => src}/Python_examples.rst | 0 doc/{rst => src}/Python_head.rst | 0 doc/{rst => src}/Python_install.rst | 0 doc/{rst => src}/Python_library.rst | 0 doc/{rst => src}/Python_mpi.rst | 0 doc/{rst => src}/Python_overview.rst | 0 doc/{rst => src}/Python_pylammps.rst | 0 doc/{rst => src}/Python_run.rst | 0 doc/{rst => src}/Python_shlib.rst | 0 doc/{rst => src}/Python_test.rst | 0 doc/{rst => src}/Run_basics.rst | 0 doc/{rst => src}/Run_head.rst | 0 doc/{rst => src}/Run_options.rst | 0 doc/{rst => src}/Run_output.rst | 0 doc/{rst => src}/Run_windows.rst | 0 doc/{rst => src}/Speed.rst | 0 doc/{rst => src}/Speed_bench.rst | 0 doc/{rst => src}/Speed_compare.rst | 0 doc/{rst => src}/Speed_gpu.rst | 0 doc/{rst => src}/Speed_intel.rst | 0 doc/{rst => src}/Speed_kokkos.rst | 0 doc/{rst => src}/Speed_measure.rst | 0 doc/{rst => src}/Speed_omp.rst | 0 doc/{rst => src}/Speed_opt.rst | 0 doc/{rst => src}/Speed_packages.rst | 0 doc/{rst => src}/Speed_tips.rst | 0 doc/{rst => src}/Tools.rst | 0 doc/{rst => src}/angle_charmm.rst | 0 doc/{rst => src}/angle_class2.rst | 0 doc/{rst => src}/angle_coeff.rst | 0 doc/{rst => src}/angle_cosine.rst | 0 doc/{rst => src}/angle_cosine_buck6d.rst | 0 doc/{rst => src}/angle_cosine_delta.rst | 0 doc/{rst => src}/angle_cosine_periodic.rst | 0 doc/{rst => src}/angle_cosine_shift.rst | 0 doc/{rst => src}/angle_cosine_shift_exp.rst | 0 doc/{rst => src}/angle_cosine_squared.rst | 0 doc/{rst => src}/angle_cross.rst | 0 doc/{rst => src}/angle_dipole.rst | 0 doc/{rst => src}/angle_fourier.rst | 0 doc/{rst => src}/angle_fourier_simple.rst | 0 doc/{rst => src}/angle_harmonic.rst | 0 doc/{rst => src}/angle_hybrid.rst | 0 doc/{rst => src}/angle_mm3.rst | 0 doc/{rst => src}/angle_none.rst | 0 doc/{rst => src}/angle_quartic.rst | 0 doc/{rst => src}/angle_sdk.rst | 0 doc/{rst => src}/angle_style.rst | 0 doc/{rst => src}/angle_table.rst | 0 doc/{rst => src}/angle_zero.rst | 0 doc/{rst => src}/angles.rst | 0 doc/{rst => src}/atom_modify.rst | 0 doc/{rst => src}/atom_style.rst | 0 doc/{rst => src}/balance.rst | 0 doc/{rst => src}/bond_class2.rst | 0 doc/{rst => src}/bond_coeff.rst | 0 doc/{rst => src}/bond_fene.rst | 0 doc/{rst => src}/bond_fene_expand.rst | 0 doc/{rst => src}/bond_gromos.rst | 0 doc/{rst => src}/bond_harmonic.rst | 0 doc/{rst => src}/bond_harmonic_shift.rst | 0 doc/{rst => src}/bond_harmonic_shift_cut.rst | 0 doc/{rst => src}/bond_hybrid.rst | 0 doc/{rst => src}/bond_mm3.rst | 0 doc/{rst => src}/bond_morse.rst | 0 doc/{rst => src}/bond_none.rst | 0 doc/{rst => src}/bond_nonlinear.rst | 0 doc/{rst => src}/bond_oxdna.rst | 0 doc/{rst => src}/bond_quartic.rst | 0 doc/{rst => src}/bond_style.rst | 0 doc/{rst => src}/bond_table.rst | 0 doc/{rst => src}/bond_write.rst | 0 doc/{rst => src}/bond_zero.rst | 0 doc/{rst => src}/bonds.rst | 0 doc/{rst => src}/boundary.rst | 0 doc/{rst => src}/box.rst | 0 doc/{rst => src}/change_box.rst | 0 doc/{rst => src}/clear.rst | 0 doc/{rst => src}/comm_modify.rst | 0 doc/{rst => src}/comm_style.rst | 0 doc/{rst => src}/commands_list.rst | 0 doc/{rst => src}/compute.rst | 0 doc/{rst => src}/compute_ackland_atom.rst | 0 doc/{rst => src}/compute_adf.rst | 0 doc/{rst => src}/compute_angle.rst | 0 doc/{rst => src}/compute_angle_local.rst | 0 doc/{rst => src}/compute_angmom_chunk.rst | 0 doc/{rst => src}/compute_basal_atom.rst | 0 doc/{rst => src}/compute_body_local.rst | 0 doc/{rst => src}/compute_bond.rst | 0 doc/{rst => src}/compute_bond_local.rst | 0 doc/{rst => src}/compute_centro_atom.rst | 0 doc/{rst => src}/compute_chunk_atom.rst | 0 .../compute_chunk_spread_atom.rst | 0 doc/{rst => src}/compute_cluster_atom.rst | 0 doc/{rst => src}/compute_cna_atom.rst | 0 doc/{rst => src}/compute_cnp_atom.rst | 0 doc/{rst => src}/compute_com.rst | 0 doc/{rst => src}/compute_com_chunk.rst | 0 doc/{rst => src}/compute_contact_atom.rst | 0 doc/{rst => src}/compute_coord_atom.rst | 0 doc/{rst => src}/compute_damage_atom.rst | 0 doc/{rst => src}/compute_dihedral.rst | 0 doc/{rst => src}/compute_dihedral_local.rst | 0 doc/{rst => src}/compute_dilatation_atom.rst | 0 doc/{rst => src}/compute_dipole_chunk.rst | 0 doc/{rst => src}/compute_displace_atom.rst | 0 doc/{rst => src}/compute_dpd.rst | 0 doc/{rst => src}/compute_dpd_atom.rst | 0 doc/{rst => src}/compute_edpd_temp_atom.rst | 0 doc/{rst => src}/compute_entropy_atom.rst | 0 doc/{rst => src}/compute_erotate_asphere.rst | 0 doc/{rst => src}/compute_erotate_rigid.rst | 0 doc/{rst => src}/compute_erotate_sphere.rst | 0 .../compute_erotate_sphere_atom.rst | 0 doc/{rst => src}/compute_event_displace.rst | 0 doc/{rst => src}/compute_fep.rst | 0 doc/{rst => src}/compute_global_atom.rst | 0 doc/{rst => src}/compute_group_group.rst | 0 doc/{rst => src}/compute_gyration.rst | 0 doc/{rst => src}/compute_gyration_chunk.rst | 0 doc/{rst => src}/compute_gyration_shape.rst | 0 doc/{rst => src}/compute_heat_flux.rst | 0 doc/{rst => src}/compute_hexorder_atom.rst | 0 doc/{rst => src}/compute_hma.rst | 0 doc/{rst => src}/compute_improper.rst | 0 doc/{rst => src}/compute_improper_local.rst | 0 doc/{rst => src}/compute_inertia_chunk.rst | 0 doc/{rst => src}/compute_ke.rst | 0 doc/{rst => src}/compute_ke_atom.rst | 0 doc/{rst => src}/compute_ke_atom_eff.rst | 0 doc/{rst => src}/compute_ke_eff.rst | 0 doc/{rst => src}/compute_ke_rigid.rst | 0 doc/{rst => src}/compute_meso_e_atom.rst | 0 doc/{rst => src}/compute_meso_rho_atom.rst | 0 doc/{rst => src}/compute_meso_t_atom.rst | 0 doc/{rst => src}/compute_modify.rst | 0 doc/{rst => src}/compute_momentum.rst | 0 doc/{rst => src}/compute_msd.rst | 0 doc/{rst => src}/compute_msd_chunk.rst | 0 doc/{rst => src}/compute_msd_nongauss.rst | 0 doc/{rst => src}/compute_omega_chunk.rst | 0 doc/{rst => src}/compute_orientorder_atom.rst | 0 doc/{rst => src}/compute_pair.rst | 0 doc/{rst => src}/compute_pair_local.rst | 0 doc/{rst => src}/compute_pe.rst | 0 doc/{rst => src}/compute_pe_atom.rst | 0 doc/{rst => src}/compute_plasticity_atom.rst | 0 doc/{rst => src}/compute_pressure.rst | 0 .../compute_pressure_cylinder.rst | 0 doc/{rst => src}/compute_pressure_uef.rst | 0 doc/{rst => src}/compute_property_atom.rst | 0 doc/{rst => src}/compute_property_chunk.rst | 0 doc/{rst => src}/compute_property_local.rst | 0 doc/{rst => src}/compute_ptm_atom.rst | 0 doc/{rst => src}/compute_rdf.rst | 0 doc/{rst => src}/compute_reduce.rst | 0 doc/{rst => src}/compute_reduce_chunk.rst | 0 doc/{rst => src}/compute_rigid_local.rst | 0 doc/{rst => src}/compute_saed.rst | 0 doc/{rst => src}/compute_slice.rst | 0 .../compute_smd_contact_radius.rst | 0 doc/{rst => src}/compute_smd_damage.rst | 0 .../compute_smd_hourglass_error.rst | 0 .../compute_smd_internal_energy.rst | 0 .../compute_smd_plastic_strain.rst | 0 .../compute_smd_plastic_strain_rate.rst | 0 doc/{rst => src}/compute_smd_rho.rst | 0 .../compute_smd_tlsph_defgrad.rst | 0 doc/{rst => src}/compute_smd_tlsph_dt.rst | 0 .../compute_smd_tlsph_num_neighs.rst | 0 doc/{rst => src}/compute_smd_tlsph_shape.rst | 0 doc/{rst => src}/compute_smd_tlsph_strain.rst | 0 .../compute_smd_tlsph_strain_rate.rst | 0 doc/{rst => src}/compute_smd_tlsph_stress.rst | 0 .../compute_smd_triangle_vertices.rst | 0 .../compute_smd_ulsph_num_neighs.rst | 0 doc/{rst => src}/compute_smd_ulsph_strain.rst | 0 .../compute_smd_ulsph_strain_rate.rst | 0 doc/{rst => src}/compute_smd_ulsph_stress.rst | 0 doc/{rst => src}/compute_smd_vol.rst | 0 doc/{rst => src}/compute_sna_atom.rst | 0 doc/{rst => src}/compute_spin.rst | 0 doc/{rst => src}/compute_stress_atom.rst | 0 doc/{rst => src}/compute_stress_mop.rst | 0 doc/{rst => src}/compute_tally.rst | 0 doc/{rst => src}/compute_tdpd_cc_atom.rst | 0 doc/{rst => src}/compute_temp.rst | 0 doc/{rst => src}/compute_temp_asphere.rst | 0 doc/{rst => src}/compute_temp_body.rst | 0 doc/{rst => src}/compute_temp_chunk.rst | 0 doc/{rst => src}/compute_temp_com.rst | 0 doc/{rst => src}/compute_temp_cs.rst | 0 doc/{rst => src}/compute_temp_deform.rst | 0 doc/{rst => src}/compute_temp_deform_eff.rst | 0 doc/{rst => src}/compute_temp_drude.rst | 0 doc/{rst => src}/compute_temp_eff.rst | 0 doc/{rst => src}/compute_temp_partial.rst | 0 doc/{rst => src}/compute_temp_profile.rst | 0 doc/{rst => src}/compute_temp_ramp.rst | 0 doc/{rst => src}/compute_temp_region.rst | 0 doc/{rst => src}/compute_temp_region_eff.rst | 0 doc/{rst => src}/compute_temp_rotate.rst | 0 doc/{rst => src}/compute_temp_sphere.rst | 0 doc/{rst => src}/compute_temp_uef.rst | 0 doc/{rst => src}/compute_ti.rst | 0 doc/{rst => src}/compute_torque_chunk.rst | 0 doc/{rst => src}/compute_vacf.rst | 0 doc/{rst => src}/compute_vcm_chunk.rst | 0 doc/{rst => src}/compute_voronoi_atom.rst | 0 doc/{rst => src}/compute_xrd.rst | 0 doc/{rst => src}/computes.rst | 0 doc/{rst => src}/create_atoms.rst | 0 doc/{rst => src}/create_bonds.rst | 0 doc/{rst => src}/create_box.rst | 0 doc/{rst => src}/delete_atoms.rst | 0 doc/{rst => src}/delete_bonds.rst | 0 doc/{rst => src}/dielectric.rst | 0 doc/{rst => src}/dihedral_charmm.rst | 0 doc/{rst => src}/dihedral_class2.rst | 0 doc/{rst => src}/dihedral_coeff.rst | 0 .../dihedral_cosine_shift_exp.rst | 0 doc/{rst => src}/dihedral_fourier.rst | 0 doc/{rst => src}/dihedral_harmonic.rst | 0 doc/{rst => src}/dihedral_helix.rst | 0 doc/{rst => src}/dihedral_hybrid.rst | 0 doc/{rst => src}/dihedral_multi_harmonic.rst | 0 doc/{rst => src}/dihedral_nharmonic.rst | 0 doc/{rst => src}/dihedral_none.rst | 0 doc/{rst => src}/dihedral_opls.rst | 0 doc/{rst => src}/dihedral_quadratic.rst | 0 doc/{rst => src}/dihedral_spherical.rst | 0 doc/{rst => src}/dihedral_style.rst | 0 doc/{rst => src}/dihedral_table.rst | 0 doc/{rst => src}/dihedral_table_cut.rst | 0 doc/{rst => src}/dihedral_zero.rst | 0 doc/{rst => src}/dihedrals.rst | 0 doc/{rst => src}/dimension.rst | 0 doc/{rst => src}/displace_atoms.rst | 0 doc/{rst => src}/dump.rst | 0 doc/{rst => src}/dump_adios.rst | 0 doc/{rst => src}/dump_cfg_uef.rst | 0 doc/{rst => src}/dump_h5md.rst | 0 doc/{rst => src}/dump_image.rst | 0 doc/{rst => src}/dump_modify.rst | 0 doc/{rst => src}/dump_molfile.rst | 0 doc/{rst => src}/dump_netcdf.rst | 0 doc/{rst => src}/dump_vtk.rst | 0 doc/{rst => src}/dynamical_matrix.rst | 0 doc/{rst => src}/echo.rst | 0 doc/{rst => src}/fix.rst | 0 doc/{rst => src}/fix_adapt.rst | 0 doc/{rst => src}/fix_adapt_fep.rst | 0 doc/{rst => src}/fix_addforce.rst | 0 doc/{rst => src}/fix_addtorque.rst | 0 doc/{rst => src}/fix_append_atoms.rst | 0 doc/{rst => src}/fix_atc.rst | 0 doc/{rst => src}/fix_atom_swap.rst | 0 doc/{rst => src}/fix_ave_atom.rst | 0 doc/{rst => src}/fix_ave_chunk.rst | 0 doc/{rst => src}/fix_ave_correlate.rst | 0 doc/{rst => src}/fix_ave_correlate_long.rst | 0 doc/{rst => src}/fix_ave_histo.rst | 0 doc/{rst => src}/fix_ave_time.rst | 0 doc/{rst => src}/fix_aveforce.rst | 0 doc/{rst => src}/fix_balance.rst | 0 doc/{rst => src}/fix_bocs.rst | 0 doc/{rst => src}/fix_bond_break.rst | 0 doc/{rst => src}/fix_bond_create.rst | 0 doc/{rst => src}/fix_bond_react.rst | 0 doc/{rst => src}/fix_bond_swap.rst | 0 doc/{rst => src}/fix_box_relax.rst | 0 doc/{rst => src}/fix_client_md.rst | 0 doc/{rst => src}/fix_cmap.rst | 0 doc/{rst => src}/fix_colvars.rst | 0 doc/{rst => src}/fix_controller.rst | 0 doc/{rst => src}/fix_deform.rst | 0 doc/{rst => src}/fix_deposit.rst | 0 doc/{rst => src}/fix_dpd_energy.rst | 0 doc/{rst => src}/fix_dpd_source.rst | 0 doc/{rst => src}/fix_drag.rst | 0 doc/{rst => src}/fix_drude.rst | 0 doc/{rst => src}/fix_drude_transform.rst | 0 doc/{rst => src}/fix_dt_reset.rst | 0 doc/{rst => src}/fix_efield.rst | 0 doc/{rst => src}/fix_ehex.rst | 0 doc/{rst => src}/fix_electron_stopping.rst | 0 doc/{rst => src}/fix_enforce2d.rst | 0 doc/{rst => src}/fix_eos_cv.rst | 0 doc/{rst => src}/fix_eos_table.rst | 0 doc/{rst => src}/fix_eos_table_rx.rst | 0 doc/{rst => src}/fix_evaporate.rst | 0 doc/{rst => src}/fix_external.rst | 0 doc/{rst => src}/fix_ffl.rst | 0 doc/{rst => src}/fix_filter_corotate.rst | 0 doc/{rst => src}/fix_flow_gauss.rst | 0 doc/{rst => src}/fix_freeze.rst | 0 doc/{rst => src}/fix_gcmc.rst | 0 doc/{rst => src}/fix_gld.rst | 0 doc/{rst => src}/fix_gle.rst | 0 doc/{rst => src}/fix_gravity.rst | 0 doc/{rst => src}/fix_grem.rst | 0 doc/{rst => src}/fix_halt.rst | 0 doc/{rst => src}/fix_heat.rst | 0 doc/{rst => src}/fix_hyper_global.rst | 0 doc/{rst => src}/fix_hyper_local.rst | 0 doc/{rst => src}/fix_imd.rst | 0 doc/{rst => src}/fix_indent.rst | 0 doc/{rst => src}/fix_ipi.rst | 0 doc/{rst => src}/fix_langevin.rst | 0 doc/{rst => src}/fix_langevin_drude.rst | 0 doc/{rst => src}/fix_langevin_eff.rst | 0 doc/{rst => src}/fix_langevin_spin.rst | 0 doc/{rst => src}/fix_latte.rst | 0 doc/{rst => src}/fix_lb_fluid.rst | 0 doc/{rst => src}/fix_lb_momentum.rst | 0 doc/{rst => src}/fix_lb_pc.rst | 0 doc/{rst => src}/fix_lb_rigid_pc_sphere.rst | 0 doc/{rst => src}/fix_lb_viscous.rst | 0 doc/{rst => src}/fix_lineforce.rst | 0 doc/{rst => src}/fix_manifoldforce.rst | 0 doc/{rst => src}/fix_meso.rst | 0 doc/{rst => src}/fix_meso_move.rst | 0 doc/{rst => src}/fix_meso_stationary.rst | 0 doc/{rst => src}/fix_modify.rst | 0 doc/{rst => src}/fix_momentum.rst | 0 doc/{rst => src}/fix_move.rst | 0 doc/{rst => src}/fix_mscg.rst | 0 doc/{rst => src}/fix_msst.rst | 0 doc/{rst => src}/fix_mvv_dpd.rst | 0 doc/{rst => src}/fix_neb.rst | 0 doc/{rst => src}/fix_neb_spin.rst | 0 doc/{rst => src}/fix_nh.rst | 0 doc/{rst => src}/fix_nh_eff.rst | 0 doc/{rst => src}/fix_nh_uef.rst | 0 doc/{rst => src}/fix_nph_asphere.rst | 0 doc/{rst => src}/fix_nph_body.rst | 0 doc/{rst => src}/fix_nph_sphere.rst | 0 doc/{rst => src}/fix_nphug.rst | 0 doc/{rst => src}/fix_npt_asphere.rst | 0 doc/{rst => src}/fix_npt_body.rst | 0 doc/{rst => src}/fix_npt_sphere.rst | 0 doc/{rst => src}/fix_nve.rst | 0 doc/{rst => src}/fix_nve_asphere.rst | 0 doc/{rst => src}/fix_nve_asphere_noforce.rst | 0 doc/{rst => src}/fix_nve_awpmd.rst | 0 doc/{rst => src}/fix_nve_body.rst | 0 doc/{rst => src}/fix_nve_dot.rst | 0 doc/{rst => src}/fix_nve_dotc_langevin.rst | 0 doc/{rst => src}/fix_nve_eff.rst | 0 doc/{rst => src}/fix_nve_limit.rst | 0 doc/{rst => src}/fix_nve_line.rst | 0 doc/{rst => src}/fix_nve_manifold_rattle.rst | 0 doc/{rst => src}/fix_nve_noforce.rst | 0 doc/{rst => src}/fix_nve_sphere.rst | 0 doc/{rst => src}/fix_nve_spin.rst | 0 doc/{rst => src}/fix_nve_tri.rst | 0 doc/{rst => src}/fix_nvk.rst | 0 doc/{rst => src}/fix_nvt_asphere.rst | 0 doc/{rst => src}/fix_nvt_body.rst | 0 doc/{rst => src}/fix_nvt_manifold_rattle.rst | 0 doc/{rst => src}/fix_nvt_sllod.rst | 0 doc/{rst => src}/fix_nvt_sllod_eff.rst | 0 doc/{rst => src}/fix_nvt_sphere.rst | 0 doc/{rst => src}/fix_oneway.rst | 0 doc/{rst => src}/fix_orient.rst | 0 doc/{rst => src}/fix_phonon.rst | 0 doc/{rst => src}/fix_pimd.rst | 0 doc/{rst => src}/fix_planeforce.rst | 0 doc/{rst => src}/fix_plumed.rst | 0 doc/{rst => src}/fix_poems.rst | 0 doc/{rst => src}/fix_pour.rst | 0 doc/{rst => src}/fix_precession_spin.rst | 0 doc/{rst => src}/fix_press_berendsen.rst | 0 doc/{rst => src}/fix_print.rst | 0 doc/{rst => src}/fix_property_atom.rst | 0 doc/{rst => src}/fix_python_invoke.rst | 0 doc/{rst => src}/fix_python_move.rst | 0 doc/{rst => src}/fix_qbmsst.rst | 0 doc/{rst => src}/fix_qeq.rst | 0 doc/{rst => src}/fix_qeq_comb.rst | 0 doc/{rst => src}/fix_qeq_reax.rst | 0 doc/{rst => src}/fix_qmmm.rst | 0 doc/{rst => src}/fix_qtb.rst | 0 doc/{rst => src}/fix_reaxc_bonds.rst | 0 doc/{rst => src}/fix_reaxc_species.rst | 0 doc/{rst => src}/fix_recenter.rst | 0 doc/{rst => src}/fix_restrain.rst | 0 doc/{rst => src}/fix_rhok.rst | 0 doc/{rst => src}/fix_rigid.rst | 0 doc/{rst => src}/fix_rigid_meso.rst | 0 doc/{rst => src}/fix_rx.rst | 0 doc/{rst => src}/fix_saed_vtk.rst | 0 doc/{rst => src}/fix_setforce.rst | 0 doc/{rst => src}/fix_shake.rst | 0 doc/{rst => src}/fix_shardlow.rst | 0 doc/{rst => src}/fix_smd.rst | 0 doc/{rst => src}/fix_smd_adjust_dt.rst | 0 doc/{rst => src}/fix_smd_integrate_tlsph.rst | 0 doc/{rst => src}/fix_smd_integrate_ulsph.rst | 0 .../fix_smd_move_triangulated_surface.rst | 0 doc/{rst => src}/fix_smd_setvel.rst | 0 doc/{rst => src}/fix_smd_wall_surface.rst | 0 doc/{rst => src}/fix_spring.rst | 0 doc/{rst => src}/fix_spring_chunk.rst | 0 doc/{rst => src}/fix_spring_rg.rst | 0 doc/{rst => src}/fix_spring_self.rst | 0 doc/{rst => src}/fix_srd.rst | 0 doc/{rst => src}/fix_store_force.rst | 0 doc/{rst => src}/fix_store_state.rst | 0 doc/{rst => src}/fix_temp_berendsen.rst | 0 doc/{rst => src}/fix_temp_csvr.rst | 0 doc/{rst => src}/fix_temp_rescale.rst | 0 doc/{rst => src}/fix_temp_rescale_eff.rst | 0 doc/{rst => src}/fix_tfmc.rst | 0 doc/{rst => src}/fix_thermal_conductivity.rst | 0 doc/{rst => src}/fix_ti_spring.rst | 0 doc/{rst => src}/fix_tmd.rst | 0 doc/{rst => src}/fix_ttm.rst | 0 doc/{rst => src}/fix_tune_kspace.rst | 0 doc/{rst => src}/fix_vector.rst | 0 doc/{rst => src}/fix_viscosity.rst | 0 doc/{rst => src}/fix_viscous.rst | 0 doc/{rst => src}/fix_wall.rst | 0 doc/{rst => src}/fix_wall_body_polygon.rst | 0 doc/{rst => src}/fix_wall_body_polyhedron.rst | 0 doc/{rst => src}/fix_wall_ees.rst | 0 doc/{rst => src}/fix_wall_gran.rst | 0 doc/{rst => src}/fix_wall_gran_region.rst | 0 doc/{rst => src}/fix_wall_piston.rst | 0 doc/{rst => src}/fix_wall_reflect.rst | 0 doc/{rst => src}/fix_wall_region.rst | 0 doc/{rst => src}/fix_wall_srd.rst | 0 doc/{rst => src}/fixes.rst | 0 doc/{rst => src}/group.rst | 0 doc/{rst => src}/group2ndx.rst | 0 doc/{rst => src}/hyper.rst | 0 doc/{rst => src}/if.rst | 0 doc/{rst => src}/improper_class2.rst | 0 doc/{rst => src}/improper_coeff.rst | 0 doc/{rst => src}/improper_cossq.rst | 0 doc/{rst => src}/improper_cvff.rst | 0 doc/{rst => src}/improper_distance.rst | 0 doc/{rst => src}/improper_distharm.rst | 0 doc/{rst => src}/improper_fourier.rst | 0 doc/{rst => src}/improper_harmonic.rst | 0 doc/{rst => src}/improper_hybrid.rst | 0 .../improper_inversion_harmonic.rst | 0 doc/{rst => src}/improper_none.rst | 0 doc/{rst => src}/improper_ring.rst | 0 doc/{rst => src}/improper_sqdistharm.rst | 0 doc/{rst => src}/improper_style.rst | 0 doc/{rst => src}/improper_umbrella.rst | 0 doc/{rst => src}/improper_zero.rst | 0 doc/{rst => src}/impropers.rst | 0 doc/{rst => src}/include.rst | 0 doc/{rst => src}/info.rst | 0 doc/{rst => src}/jump.rst | 0 doc/{rst => src}/kim_commands.rst | 0 doc/{rst => src}/kspace_modify.rst | 0 doc/{rst => src}/kspace_style.rst | 0 doc/{rst => src}/label.rst | 0 doc/{rst => src}/lattice.rst | 0 doc/{rst => src}/log.rst | 0 doc/{rst => src}/mass.rst | 0 doc/{rst => src}/message.rst | 0 doc/{rst => src}/min_modify.rst | 0 doc/{rst => src}/min_spin.rst | 0 doc/{rst => src}/min_style.rst | 0 doc/{rst => src}/minimize.rst | 0 doc/{rst => src}/molecule.rst | 0 doc/{rst => src}/neb.rst | 0 doc/{rst => src}/neb_spin.rst | 0 doc/{rst => src}/neigh_modify.rst | 0 doc/{rst => src}/neighbor.rst | 0 doc/{rst => src}/newton.rst | 0 doc/{rst => src}/next.rst | 0 doc/{rst => src}/package.rst | 0 doc/{rst => src}/pair_adp.rst | 0 doc/{rst => src}/pair_agni.rst | 0 doc/{rst => src}/pair_airebo.rst | 0 doc/{rst => src}/pair_atm.rst | 0 doc/{rst => src}/pair_awpmd.rst | 0 doc/{rst => src}/pair_beck.rst | 0 doc/{rst => src}/pair_body_nparticle.rst | 0 .../pair_body_rounded_polygon.rst | 0 .../pair_body_rounded_polyhedron.rst | 0 doc/{rst => src}/pair_bop.rst | 0 doc/{rst => src}/pair_born.rst | 0 doc/{rst => src}/pair_brownian.rst | 0 doc/{rst => src}/pair_buck.rst | 0 doc/{rst => src}/pair_buck6d_coul_gauss.rst | 0 doc/{rst => src}/pair_buck_long.rst | 0 doc/{rst => src}/pair_charmm.rst | 0 doc/{rst => src}/pair_class2.rst | 0 doc/{rst => src}/pair_coeff.rst | 0 doc/{rst => src}/pair_colloid.rst | 0 doc/{rst => src}/pair_comb.rst | 0 doc/{rst => src}/pair_cosine_squared.rst | 0 doc/{rst => src}/pair_coul.rst | 0 doc/{rst => src}/pair_coul_diel.rst | 0 doc/{rst => src}/pair_coul_shield.rst | 0 doc/{rst => src}/pair_cs.rst | 0 doc/{rst => src}/pair_dipole.rst | 0 doc/{rst => src}/pair_dpd.rst | 0 doc/{rst => src}/pair_dpd_fdt.rst | 0 doc/{rst => src}/pair_drip.rst | 0 doc/{rst => src}/pair_dsmc.rst | 0 doc/{rst => src}/pair_e3b.rst | 0 doc/{rst => src}/pair_eam.rst | 0 doc/{rst => src}/pair_edip.rst | 0 doc/{rst => src}/pair_eff.rst | 0 doc/{rst => src}/pair_eim.rst | 0 doc/{rst => src}/pair_exp6_rx.rst | 0 doc/{rst => src}/pair_extep.rst | 0 doc/{rst => src}/pair_fep_soft.rst | 0 doc/{rst => src}/pair_gauss.rst | 0 doc/{rst => src}/pair_gayberne.rst | 0 doc/{rst => src}/pair_gran.rst | 0 doc/{rst => src}/pair_granular.rst | 0 doc/{rst => src}/pair_gromacs.rst | 0 doc/{rst => src}/pair_gw.rst | 0 doc/{rst => src}/pair_hbond_dreiding.rst | 0 doc/{rst => src}/pair_hybrid.rst | 0 doc/{rst => src}/pair_ilp_graphene_hbn.rst | 0 doc/{rst => src}/pair_kim.rst | 0 .../pair_kolmogorov_crespi_full.rst | 0 doc/{rst => src}/pair_kolmogorov_crespi_z.rst | 0 doc/{rst => src}/pair_lcbop.rst | 0 doc/{rst => src}/pair_lebedeva_z.rst | 0 doc/{rst => src}/pair_line_lj.rst | 0 doc/{rst => src}/pair_list.rst | 0 doc/{rst => src}/pair_lj.rst | 0 doc/{rst => src}/pair_lj96.rst | 0 doc/{rst => src}/pair_lj_cubic.rst | 0 doc/{rst => src}/pair_lj_expand.rst | 0 doc/{rst => src}/pair_lj_long.rst | 0 doc/{rst => src}/pair_lj_smooth.rst | 0 doc/{rst => src}/pair_lj_smooth_linear.rst | 0 .../pair_lj_switch3_coulgauss.rst | 0 doc/{rst => src}/pair_local_density.rst | 0 doc/{rst => src}/pair_lubricate.rst | 0 doc/{rst => src}/pair_lubricateU.rst | 0 doc/{rst => src}/pair_mdf.rst | 0 doc/{rst => src}/pair_meam_spline.rst | 0 doc/{rst => src}/pair_meam_sw_spline.rst | 0 doc/{rst => src}/pair_meamc.rst | 0 doc/{rst => src}/pair_meso.rst | 0 doc/{rst => src}/pair_mgpt.rst | 0 doc/{rst => src}/pair_mie.rst | 0 .../pair_mm3_switch3_coulgauss.rst | 0 doc/{rst => src}/pair_modify.rst | 0 doc/{rst => src}/pair_momb.rst | 0 doc/{rst => src}/pair_morse.rst | 0 doc/{rst => src}/pair_multi_lucy.rst | 0 doc/{rst => src}/pair_multi_lucy_rx.rst | 0 doc/{rst => src}/pair_nb3b_harmonic.rst | 0 doc/{rst => src}/pair_nm.rst | 0 doc/{rst => src}/pair_none.rst | 0 doc/{rst => src}/pair_oxdna.rst | 0 doc/{rst => src}/pair_oxdna2.rst | 0 doc/{rst => src}/pair_peri.rst | 0 doc/{rst => src}/pair_polymorphic.rst | 0 doc/{rst => src}/pair_python.rst | 0 doc/{rst => src}/pair_quip.rst | 0 doc/{rst => src}/pair_reaxc.rst | 0 doc/{rst => src}/pair_resquared.rst | 0 doc/{rst => src}/pair_sdk.rst | 0 .../pair_sdpd_taitwater_isothermal.rst | 0 doc/{rst => src}/pair_smd_hertz.rst | 0 doc/{rst => src}/pair_smd_tlsph.rst | 0 .../pair_smd_triangulated_surface.rst | 0 doc/{rst => src}/pair_smd_ulsph.rst | 0 doc/{rst => src}/pair_smtbq.rst | 0 doc/{rst => src}/pair_snap.rst | 0 doc/{rst => src}/pair_soft.rst | 0 doc/{rst => src}/pair_sph_heatconduction.rst | 0 doc/{rst => src}/pair_sph_idealgas.rst | 0 doc/{rst => src}/pair_sph_lj.rst | 0 doc/{rst => src}/pair_sph_rhosum.rst | 0 doc/{rst => src}/pair_sph_taitwater.rst | 0 .../pair_sph_taitwater_morris.rst | 0 doc/{rst => src}/pair_spin_dipole.rst | 0 doc/{rst => src}/pair_spin_dmi.rst | 0 doc/{rst => src}/pair_spin_exchange.rst | 0 doc/{rst => src}/pair_spin_magelec.rst | 0 doc/{rst => src}/pair_spin_neel.rst | 0 doc/{rst => src}/pair_srp.rst | 0 doc/{rst => src}/pair_style.rst | 0 doc/{rst => src}/pair_sw.rst | 0 doc/{rst => src}/pair_table.rst | 0 doc/{rst => src}/pair_table_rx.rst | 0 doc/{rst => src}/pair_tersoff.rst | 0 doc/{rst => src}/pair_tersoff_mod.rst | 0 doc/{rst => src}/pair_tersoff_zbl.rst | 0 doc/{rst => src}/pair_thole.rst | 0 doc/{rst => src}/pair_tri_lj.rst | 0 doc/{rst => src}/pair_ufm.rst | 0 doc/{rst => src}/pair_vashishta.rst | 0 doc/{rst => src}/pair_write.rst | 0 doc/{rst => src}/pair_yukawa.rst | 0 doc/{rst => src}/pair_yukawa_colloid.rst | 0 doc/{rst => src}/pair_zbl.rst | 0 doc/{rst => src}/pair_zero.rst | 0 doc/{rst => src}/pairs.rst | 0 doc/{rst => src}/partition.rst | 0 doc/{rst => src}/prd.rst | 0 doc/{rst => src}/print.rst | 0 doc/{rst => src}/processors.rst | 0 doc/{rst => src}/python.rst | 0 doc/{rst => src}/quit.rst | 0 doc/{rst => src}/read_data.rst | 0 doc/{rst => src}/read_dump.rst | 0 doc/{rst => src}/read_restart.rst | 0 doc/{rst => src}/region.rst | 0 doc/{rst => src}/replicate.rst | 0 doc/{rst => src}/rerun.rst | 0 doc/{rst => src}/reset_ids.rst | 0 doc/{rst => src}/reset_timestep.rst | 0 doc/{rst => src}/restart.rst | 0 doc/{rst => src}/run.rst | 0 doc/{rst => src}/run_style.rst | 0 doc/{rst => src}/server.rst | 0 doc/{rst => src}/server_mc.rst | 0 doc/{rst => src}/server_md.rst | 0 doc/{rst => src}/set.rst | 0 doc/{rst => src}/shell.rst | 0 doc/{rst => src}/special_bonds.rst | 0 doc/{rst => src}/suffix.rst | 0 doc/{rst => src}/tad.rst | 0 doc/{rst => src}/temper.rst | 0 doc/{rst => src}/temper_grem.rst | 0 doc/{rst => src}/temper_npt.rst | 0 doc/{rst => src}/thermo.rst | 0 doc/{rst => src}/thermo_modify.rst | 0 doc/{rst => src}/thermo_style.rst | 0 doc/{rst => src}/third_order.rst | 0 doc/{rst => src}/timer.rst | 0 doc/{rst => src}/timestep.rst | 0 doc/{rst => src}/uncompute.rst | 0 doc/{rst => src}/undump.rst | 0 doc/{rst => src}/unfix.rst | 0 doc/{rst => src}/units.rst | 0 doc/{rst => src}/variable.rst | 0 doc/{rst => src}/velocity.rst | 0 doc/{rst => src}/write_coeff.rst | 0 doc/{rst => src}/write_data.rst | 0 doc/{rst => src}/write_dump.rst | 0 doc/{rst => src}/write_restart.rst | 0 doc/{src => txt}/Build.txt | 0 doc/{src => txt}/Build_basics.txt | 0 doc/{src => txt}/Build_cmake.txt | 0 doc/{src => txt}/Build_development.txt | 0 doc/{src => txt}/Build_extras.txt | 0 doc/{src => txt}/Build_link.txt | 0 doc/{src => txt}/Build_make.txt | 0 doc/{src => txt}/Build_package.txt | 0 doc/{src => txt}/Build_settings.txt | 0 doc/{src => txt}/Build_windows.txt | 0 doc/{src => txt}/Commands.txt | 0 doc/{src => txt}/Commands_all.txt | 0 doc/{src => txt}/Commands_bond.txt | 0 doc/{src => txt}/Commands_category.txt | 0 doc/{src => txt}/Commands_compute.txt | 0 doc/{src => txt}/Commands_fix.txt | 0 doc/{src => txt}/Commands_input.txt | 0 doc/{src => txt}/Commands_kspace.txt | 0 doc/{src => txt}/Commands_pair.txt | 0 doc/{src => txt}/Commands_parse.txt | 0 doc/{src => txt}/Commands_removed.txt | 0 doc/{src => txt}/Commands_structure.txt | 0 doc/{src => txt}/Developer/.gitignore | 0 doc/{src => txt}/Developer/classes.fig | 0 doc/{src => txt}/Developer/classes.pdf | Bin doc/{src => txt}/Developer/developer.tex | 0 doc/{src => txt}/Errors.txt | 0 doc/{src => txt}/Errors_bugs.txt | 0 doc/{src => txt}/Errors_common.txt | 0 doc/{src => txt}/Errors_messages.txt | 0 doc/{src => txt}/Errors_warnings.txt | 0 doc/{src => txt}/Examples.txt | 0 doc/{src => txt}/Howto.txt | 0 doc/{src => txt}/Howto_2d.txt | 0 doc/{src => txt}/Howto_barostat.txt | 0 doc/{src => txt}/Howto_bash.txt | 0 doc/{src => txt}/Howto_bioFF.txt | 0 doc/{src => txt}/Howto_body.txt | 0 doc/{src => txt}/Howto_chunk.txt | 0 doc/{src => txt}/Howto_client_server.txt | 0 doc/{src => txt}/Howto_coreshell.txt | 0 doc/{src => txt}/Howto_couple.txt | 0 doc/{src => txt}/Howto_diffusion.txt | 0 doc/{src => txt}/Howto_dispersion.txt | 0 doc/{src => txt}/Howto_drude.txt | 0 doc/{src => txt}/Howto_drude2.txt | 0 doc/{src => txt}/Howto_elastic.txt | 0 doc/{src => txt}/Howto_github.txt | 0 doc/{src => txt}/Howto_granular.txt | 0 doc/{src => txt}/Howto_kappa.txt | 0 doc/{src => txt}/Howto_library.txt | 0 doc/{src => txt}/Howto_manifold.txt | 0 doc/{src => txt}/Howto_multiple.txt | 0 doc/{src => txt}/Howto_nemd.txt | 0 doc/{src => txt}/Howto_output.txt | 0 doc/{src => txt}/Howto_polarizable.txt | 0 doc/{src => txt}/Howto_pylammps.txt | 0 doc/{src => txt}/Howto_replica.txt | 0 doc/{src => txt}/Howto_restart.txt | 0 doc/{src => txt}/Howto_spc.txt | 0 doc/{src => txt}/Howto_spherical.txt | 0 doc/{src => txt}/Howto_spins.txt | 0 doc/{src => txt}/Howto_temperature.txt | 0 doc/{src => txt}/Howto_thermostat.txt | 0 doc/{src => txt}/Howto_tip3p.txt | 0 doc/{src => txt}/Howto_tip4p.txt | 0 doc/{src => txt}/Howto_triclinic.txt | 0 doc/{src => txt}/Howto_viscosity.txt | 0 doc/{src => txt}/Howto_viz.txt | 0 doc/{src => txt}/Howto_walls.txt | 0 doc/{src => txt}/Install.txt | 0 doc/{src => txt}/Install_git.txt | 0 doc/{src => txt}/Install_linux.txt | 0 doc/{src => txt}/Install_mac.txt | 0 doc/{src => txt}/Install_patch.txt | 0 doc/{src => txt}/Install_svn.txt | 0 doc/{src => txt}/Install_tarball.txt | 0 doc/{src => txt}/Install_windows.txt | 0 doc/{src => txt}/Intro.txt | 0 doc/{src => txt}/Intro_authors.txt | 0 doc/{src => txt}/Intro_features.txt | 0 doc/{src => txt}/Intro_nonfeatures.txt | 0 doc/{src => txt}/Intro_opensource.txt | 0 doc/{src => txt}/Intro_overview.txt | 0 doc/{src => txt}/Intro_website.txt | 0 doc/{src => txt}/Manual.txt | 0 doc/{src => txt}/Manual_build.txt | 0 doc/{src => txt}/Manual_version.txt | 0 doc/{src => txt}/Modify.txt | 0 doc/{src => txt}/Modify_atom.txt | 0 doc/{src => txt}/Modify_body.txt | 0 doc/{src => txt}/Modify_bond.txt | 0 doc/{src => txt}/Modify_command.txt | 0 doc/{src => txt}/Modify_compute.txt | 0 doc/{src => txt}/Modify_contribute.txt | 0 doc/{src => txt}/Modify_dump.txt | 0 doc/{src => txt}/Modify_fix.txt | 0 doc/{src => txt}/Modify_kspace.txt | 0 doc/{src => txt}/Modify_min.txt | 0 doc/{src => txt}/Modify_overview.txt | 0 doc/{src => txt}/Modify_pair.txt | 0 doc/{src => txt}/Modify_region.txt | 0 doc/{src => txt}/Modify_thermo.txt | 0 doc/{src => txt}/Modify_variable.txt | 0 doc/{src => txt}/Packages.txt | 0 doc/{src => txt}/Packages_details.txt | 0 doc/{src => txt}/Packages_standard.txt | 0 doc/{src => txt}/Packages_user.txt | 0 doc/{src => txt}/Python_call.txt | 0 doc/{src => txt}/Python_examples.txt | 0 doc/{src => txt}/Python_head.txt | 0 doc/{src => txt}/Python_install.txt | 0 doc/{src => txt}/Python_library.txt | 0 doc/{src => txt}/Python_mpi.txt | 0 doc/{src => txt}/Python_overview.txt | 0 doc/{src => txt}/Python_pylammps.txt | 0 doc/{src => txt}/Python_run.txt | 0 doc/{src => txt}/Python_shlib.txt | 0 doc/{src => txt}/Python_test.txt | 0 doc/{src => txt}/Run_basics.txt | 0 doc/{src => txt}/Run_head.txt | 0 doc/{src => txt}/Run_options.txt | 0 doc/{src => txt}/Run_output.txt | 0 doc/{src => txt}/Run_windows.txt | 0 doc/{src => txt}/Speed.txt | 0 doc/{src => txt}/Speed_bench.txt | 0 doc/{src => txt}/Speed_compare.txt | 0 doc/{src => txt}/Speed_gpu.txt | 0 doc/{src => txt}/Speed_intel.txt | 0 doc/{src => txt}/Speed_kokkos.txt | 0 doc/{src => txt}/Speed_measure.txt | 0 doc/{src => txt}/Speed_omp.txt | 0 doc/{src => txt}/Speed_opt.txt | 0 doc/{src => txt}/Speed_packages.txt | 0 doc/{src => txt}/Speed_tips.txt | 0 doc/{src => txt}/Tools.txt | 0 doc/{src => txt}/angle_charmm.txt | 0 doc/{src => txt}/angle_class2.txt | 0 doc/{src => txt}/angle_coeff.txt | 0 doc/{src => txt}/angle_cosine.txt | 0 doc/{src => txt}/angle_cosine_buck6d.txt | 0 doc/{src => txt}/angle_cosine_delta.txt | 0 doc/{src => txt}/angle_cosine_periodic.txt | 0 doc/{src => txt}/angle_cosine_shift.txt | 0 doc/{src => txt}/angle_cosine_shift_exp.txt | 0 doc/{src => txt}/angle_cosine_squared.txt | 0 doc/{src => txt}/angle_cross.txt | 0 doc/{src => txt}/angle_dipole.txt | 0 doc/{src => txt}/angle_fourier.txt | 0 doc/{src => txt}/angle_fourier_simple.txt | 0 doc/{src => txt}/angle_harmonic.txt | 0 doc/{src => txt}/angle_hybrid.txt | 0 doc/{src => txt}/angle_mm3.txt | 0 doc/{src => txt}/angle_none.txt | 0 doc/{src => txt}/angle_quartic.txt | 0 doc/{src => txt}/angle_sdk.txt | 0 doc/{src => txt}/angle_style.txt | 0 doc/{src => txt}/angle_table.txt | 0 doc/{src => txt}/angle_zero.txt | 0 doc/{src => txt}/angles.txt | 0 doc/{src => txt}/atom_modify.txt | 0 doc/{src => txt}/atom_style.txt | 0 doc/{src => txt}/balance.txt | 0 doc/{src => txt}/bond_class2.txt | 0 doc/{src => txt}/bond_coeff.txt | 0 doc/{src => txt}/bond_fene.txt | 0 doc/{src => txt}/bond_fene_expand.txt | 0 doc/{src => txt}/bond_gromos.txt | 0 doc/{src => txt}/bond_harmonic.txt | 0 doc/{src => txt}/bond_harmonic_shift.txt | 0 doc/{src => txt}/bond_harmonic_shift_cut.txt | 0 doc/{src => txt}/bond_hybrid.txt | 0 doc/{src => txt}/bond_mm3.txt | 0 doc/{src => txt}/bond_morse.txt | 0 doc/{src => txt}/bond_none.txt | 0 doc/{src => txt}/bond_nonlinear.txt | 0 doc/{src => txt}/bond_oxdna.txt | 0 doc/{src => txt}/bond_quartic.txt | 0 doc/{src => txt}/bond_style.txt | 0 doc/{src => txt}/bond_table.txt | 0 doc/{src => txt}/bond_write.txt | 0 doc/{src => txt}/bond_zero.txt | 0 doc/{src => txt}/bonds.txt | 0 doc/{src => txt}/boundary.txt | 0 doc/{src => txt}/box.txt | 0 doc/{src => txt}/change_box.txt | 0 doc/{src => txt}/clear.txt | 0 doc/{src => txt}/comm_modify.txt | 0 doc/{src => txt}/comm_style.txt | 0 doc/{src => txt}/commands_list.txt | 0 doc/{src => txt}/compute.txt | 0 doc/{src => txt}/compute_ackland_atom.txt | 0 doc/{src => txt}/compute_adf.txt | 0 doc/{src => txt}/compute_angle.txt | 0 doc/{src => txt}/compute_angle_local.txt | 0 doc/{src => txt}/compute_angmom_chunk.txt | 0 doc/{src => txt}/compute_basal_atom.txt | 0 doc/{src => txt}/compute_body_local.txt | 0 doc/{src => txt}/compute_bond.txt | 0 doc/{src => txt}/compute_bond_local.txt | 0 doc/{src => txt}/compute_centro_atom.txt | 0 doc/{src => txt}/compute_chunk_atom.txt | 0 .../compute_chunk_spread_atom.txt | 0 doc/{src => txt}/compute_cluster_atom.txt | 0 doc/{src => txt}/compute_cna_atom.txt | 0 doc/{src => txt}/compute_cnp_atom.txt | 0 doc/{src => txt}/compute_com.txt | 0 doc/{src => txt}/compute_com_chunk.txt | 0 doc/{src => txt}/compute_contact_atom.txt | 0 doc/{src => txt}/compute_coord_atom.txt | 0 doc/{src => txt}/compute_damage_atom.txt | 0 doc/{src => txt}/compute_dihedral.txt | 0 doc/{src => txt}/compute_dihedral_local.txt | 0 doc/{src => txt}/compute_dilatation_atom.txt | 0 doc/{src => txt}/compute_dipole_chunk.txt | 0 doc/{src => txt}/compute_displace_atom.txt | 0 doc/{src => txt}/compute_dpd.txt | 0 doc/{src => txt}/compute_dpd_atom.txt | 0 doc/{src => txt}/compute_edpd_temp_atom.txt | 0 doc/{src => txt}/compute_entropy_atom.txt | 0 doc/{src => txt}/compute_erotate_asphere.txt | 0 doc/{src => txt}/compute_erotate_rigid.txt | 0 doc/{src => txt}/compute_erotate_sphere.txt | 0 .../compute_erotate_sphere_atom.txt | 0 doc/{src => txt}/compute_event_displace.txt | 0 doc/{src => txt}/compute_fep.txt | 0 doc/{src => txt}/compute_global_atom.txt | 0 doc/{src => txt}/compute_group_group.txt | 0 doc/{src => txt}/compute_gyration.txt | 0 doc/{src => txt}/compute_gyration_chunk.txt | 0 doc/{src => txt}/compute_gyration_shape.txt | 0 doc/{src => txt}/compute_heat_flux.txt | 0 doc/{src => txt}/compute_hexorder_atom.txt | 0 doc/{src => txt}/compute_hma.txt | 0 doc/{src => txt}/compute_improper.txt | 0 doc/{src => txt}/compute_improper_local.txt | 0 doc/{src => txt}/compute_inertia_chunk.txt | 0 doc/{src => txt}/compute_ke.txt | 0 doc/{src => txt}/compute_ke_atom.txt | 0 doc/{src => txt}/compute_ke_atom_eff.txt | 0 doc/{src => txt}/compute_ke_eff.txt | 0 doc/{src => txt}/compute_ke_rigid.txt | 0 doc/{src => txt}/compute_meso_e_atom.txt | 0 doc/{src => txt}/compute_meso_rho_atom.txt | 0 doc/{src => txt}/compute_meso_t_atom.txt | 0 doc/{src => txt}/compute_modify.txt | 0 doc/{src => txt}/compute_momentum.txt | 0 doc/{src => txt}/compute_msd.txt | 0 doc/{src => txt}/compute_msd_chunk.txt | 0 doc/{src => txt}/compute_msd_nongauss.txt | 0 doc/{src => txt}/compute_omega_chunk.txt | 0 doc/{src => txt}/compute_orientorder_atom.txt | 0 doc/{src => txt}/compute_pair.txt | 0 doc/{src => txt}/compute_pair_local.txt | 0 doc/{src => txt}/compute_pe.txt | 0 doc/{src => txt}/compute_pe_atom.txt | 0 doc/{src => txt}/compute_plasticity_atom.txt | 0 doc/{src => txt}/compute_pressure.txt | 0 .../compute_pressure_cylinder.txt | 0 doc/{src => txt}/compute_pressure_uef.txt | 0 doc/{src => txt}/compute_property_atom.txt | 0 doc/{src => txt}/compute_property_chunk.txt | 0 doc/{src => txt}/compute_property_local.txt | 0 doc/{src => txt}/compute_ptm_atom.txt | 0 doc/{src => txt}/compute_rdf.txt | 0 doc/{src => txt}/compute_reduce.txt | 0 doc/{src => txt}/compute_reduce_chunk.txt | 0 doc/{src => txt}/compute_rigid_local.txt | 0 doc/{src => txt}/compute_saed.txt | 0 doc/{src => txt}/compute_slice.txt | 0 .../compute_smd_contact_radius.txt | 0 doc/{src => txt}/compute_smd_damage.txt | 0 .../compute_smd_hourglass_error.txt | 0 .../compute_smd_internal_energy.txt | 0 .../compute_smd_plastic_strain.txt | 0 .../compute_smd_plastic_strain_rate.txt | 0 doc/{src => txt}/compute_smd_rho.txt | 0 .../compute_smd_tlsph_defgrad.txt | 0 doc/{src => txt}/compute_smd_tlsph_dt.txt | 0 .../compute_smd_tlsph_num_neighs.txt | 0 doc/{src => txt}/compute_smd_tlsph_shape.txt | 0 doc/{src => txt}/compute_smd_tlsph_strain.txt | 0 .../compute_smd_tlsph_strain_rate.txt | 0 doc/{src => txt}/compute_smd_tlsph_stress.txt | 0 .../compute_smd_triangle_vertices.txt | 0 .../compute_smd_ulsph_num_neighs.txt | 0 doc/{src => txt}/compute_smd_ulsph_strain.txt | 0 .../compute_smd_ulsph_strain_rate.txt | 0 doc/{src => txt}/compute_smd_ulsph_stress.txt | 0 doc/{src => txt}/compute_smd_vol.txt | 0 doc/{src => txt}/compute_sna_atom.txt | 0 doc/{src => txt}/compute_spin.txt | 0 doc/{src => txt}/compute_stress_atom.txt | 0 doc/{src => txt}/compute_stress_mop.txt | 0 doc/{src => txt}/compute_tally.txt | 0 doc/{src => txt}/compute_tdpd_cc_atom.txt | 0 doc/{src => txt}/compute_temp.txt | 0 doc/{src => txt}/compute_temp_asphere.txt | 0 doc/{src => txt}/compute_temp_body.txt | 0 doc/{src => txt}/compute_temp_chunk.txt | 0 doc/{src => txt}/compute_temp_com.txt | 0 doc/{src => txt}/compute_temp_cs.txt | 0 doc/{src => txt}/compute_temp_deform.txt | 0 doc/{src => txt}/compute_temp_deform_eff.txt | 0 doc/{src => txt}/compute_temp_drude.txt | 0 doc/{src => txt}/compute_temp_eff.txt | 0 doc/{src => txt}/compute_temp_partial.txt | 0 doc/{src => txt}/compute_temp_profile.txt | 0 doc/{src => txt}/compute_temp_ramp.txt | 0 doc/{src => txt}/compute_temp_region.txt | 0 doc/{src => txt}/compute_temp_region_eff.txt | 0 doc/{src => txt}/compute_temp_rotate.txt | 0 doc/{src => txt}/compute_temp_sphere.txt | 0 doc/{src => txt}/compute_temp_uef.txt | 0 doc/{src => txt}/compute_ti.txt | 0 doc/{src => txt}/compute_torque_chunk.txt | 0 doc/{src => txt}/compute_vacf.txt | 0 doc/{src => txt}/compute_vcm_chunk.txt | 0 doc/{src => txt}/compute_voronoi_atom.txt | 0 doc/{src => txt}/compute_xrd.txt | 0 doc/{src => txt}/computes.txt | 0 doc/{src => txt}/create_atoms.txt | 0 doc/{src => txt}/create_bonds.txt | 0 doc/{src => txt}/create_box.txt | 0 doc/{src => txt}/delete_atoms.txt | 0 doc/{src => txt}/delete_bonds.txt | 0 doc/{src => txt}/dielectric.txt | 0 doc/{src => txt}/dihedral_charmm.txt | 0 doc/{src => txt}/dihedral_class2.txt | 0 doc/{src => txt}/dihedral_coeff.txt | 0 .../dihedral_cosine_shift_exp.txt | 0 doc/{src => txt}/dihedral_fourier.txt | 0 doc/{src => txt}/dihedral_harmonic.txt | 0 doc/{src => txt}/dihedral_helix.txt | 0 doc/{src => txt}/dihedral_hybrid.txt | 0 doc/{src => txt}/dihedral_multi_harmonic.txt | 0 doc/{src => txt}/dihedral_nharmonic.txt | 0 doc/{src => txt}/dihedral_none.txt | 0 doc/{src => txt}/dihedral_opls.txt | 0 doc/{src => txt}/dihedral_quadratic.txt | 0 doc/{src => txt}/dihedral_spherical.txt | 0 doc/{src => txt}/dihedral_style.txt | 0 doc/{src => txt}/dihedral_table.txt | 0 doc/{src => txt}/dihedral_table_cut.txt | 0 doc/{src => txt}/dihedral_zero.txt | 0 doc/{src => txt}/dihedrals.txt | 0 doc/{src => txt}/dimension.txt | 0 doc/{src => txt}/displace_atoms.txt | 0 doc/{src => txt}/dump.txt | 0 doc/{src => txt}/dump_adios.txt | 0 doc/{src => txt}/dump_cfg_uef.txt | 0 doc/{src => txt}/dump_h5md.txt | 0 doc/{src => txt}/dump_image.txt | 0 doc/{src => txt}/dump_modify.txt | 0 doc/{src => txt}/dump_molfile.txt | 0 doc/{src => txt}/dump_netcdf.txt | 0 doc/{src => txt}/dump_vtk.txt | 0 doc/{src => txt}/dynamical_matrix.txt | 0 doc/{src => txt}/echo.txt | 0 doc/{src => txt}/fix.txt | 0 doc/{src => txt}/fix_adapt.txt | 0 doc/{src => txt}/fix_adapt_fep.txt | 0 doc/{src => txt}/fix_addforce.txt | 0 doc/{src => txt}/fix_addtorque.txt | 0 doc/{src => txt}/fix_append_atoms.txt | 0 doc/{src => txt}/fix_atc.txt | 0 doc/{src => txt}/fix_atom_swap.txt | 0 doc/{src => txt}/fix_ave_atom.txt | 0 doc/{src => txt}/fix_ave_chunk.txt | 0 doc/{src => txt}/fix_ave_correlate.txt | 0 doc/{src => txt}/fix_ave_correlate_long.txt | 0 doc/{src => txt}/fix_ave_histo.txt | 0 doc/{src => txt}/fix_ave_time.txt | 0 doc/{src => txt}/fix_aveforce.txt | 0 doc/{src => txt}/fix_balance.txt | 0 doc/{src => txt}/fix_bocs.txt | 0 doc/{src => txt}/fix_bond_break.txt | 0 doc/{src => txt}/fix_bond_create.txt | 0 doc/{src => txt}/fix_bond_react.txt | 0 doc/{src => txt}/fix_bond_swap.txt | 0 doc/{src => txt}/fix_box_relax.txt | 0 doc/{src => txt}/fix_client_md.txt | 0 doc/{src => txt}/fix_cmap.txt | 0 doc/{src => txt}/fix_colvars.txt | 0 doc/{src => txt}/fix_controller.txt | 0 doc/{src => txt}/fix_deform.txt | 0 doc/{src => txt}/fix_deposit.txt | 0 doc/{src => txt}/fix_dpd_energy.txt | 0 doc/{src => txt}/fix_dpd_source.txt | 0 doc/{src => txt}/fix_drag.txt | 0 doc/{src => txt}/fix_drude.txt | 0 doc/{src => txt}/fix_drude_transform.txt | 0 doc/{src => txt}/fix_dt_reset.txt | 0 doc/{src => txt}/fix_efield.txt | 0 doc/{src => txt}/fix_ehex.txt | 0 doc/{src => txt}/fix_electron_stopping.txt | 0 doc/{src => txt}/fix_enforce2d.txt | 0 doc/{src => txt}/fix_eos_cv.txt | 0 doc/{src => txt}/fix_eos_table.txt | 0 doc/{src => txt}/fix_eos_table_rx.txt | 0 doc/{src => txt}/fix_evaporate.txt | 0 doc/{src => txt}/fix_external.txt | 0 doc/{src => txt}/fix_ffl.txt | 0 doc/{src => txt}/fix_filter_corotate.txt | 0 doc/{src => txt}/fix_flow_gauss.txt | 0 doc/{src => txt}/fix_freeze.txt | 0 doc/{src => txt}/fix_gcmc.txt | 0 doc/{src => txt}/fix_gld.txt | 0 doc/{src => txt}/fix_gle.txt | 0 doc/{src => txt}/fix_gravity.txt | 0 doc/{src => txt}/fix_grem.txt | 0 doc/{src => txt}/fix_halt.txt | 0 doc/{src => txt}/fix_heat.txt | 0 doc/{src => txt}/fix_hyper_global.txt | 0 doc/{src => txt}/fix_hyper_local.txt | 0 doc/{src => txt}/fix_imd.txt | 0 doc/{src => txt}/fix_indent.txt | 0 doc/{src => txt}/fix_ipi.txt | 0 doc/{src => txt}/fix_langevin.txt | 0 doc/{src => txt}/fix_langevin_drude.txt | 0 doc/{src => txt}/fix_langevin_eff.txt | 0 doc/{src => txt}/fix_langevin_spin.txt | 0 doc/{src => txt}/fix_latte.txt | 0 doc/{src => txt}/fix_lb_fluid.txt | 0 doc/{src => txt}/fix_lb_momentum.txt | 0 doc/{src => txt}/fix_lb_pc.txt | 0 doc/{src => txt}/fix_lb_rigid_pc_sphere.txt | 0 doc/{src => txt}/fix_lb_viscous.txt | 0 doc/{src => txt}/fix_lineforce.txt | 0 doc/{src => txt}/fix_manifoldforce.txt | 0 doc/{src => txt}/fix_meso.txt | 0 doc/{src => txt}/fix_meso_move.txt | 0 doc/{src => txt}/fix_meso_stationary.txt | 0 doc/{src => txt}/fix_modify.txt | 0 doc/{src => txt}/fix_momentum.txt | 0 doc/{src => txt}/fix_move.txt | 0 doc/{src => txt}/fix_mscg.txt | 0 doc/{src => txt}/fix_msst.txt | 0 doc/{src => txt}/fix_mvv_dpd.txt | 0 doc/{src => txt}/fix_neb.txt | 0 doc/{src => txt}/fix_neb_spin.txt | 0 doc/{src => txt}/fix_nh.txt | 0 doc/{src => txt}/fix_nh_eff.txt | 0 doc/{src => txt}/fix_nh_uef.txt | 0 doc/{src => txt}/fix_nph_asphere.txt | 0 doc/{src => txt}/fix_nph_body.txt | 0 doc/{src => txt}/fix_nph_sphere.txt | 0 doc/{src => txt}/fix_nphug.txt | 0 doc/{src => txt}/fix_npt_asphere.txt | 0 doc/{src => txt}/fix_npt_body.txt | 0 doc/{src => txt}/fix_npt_sphere.txt | 0 doc/{src => txt}/fix_nve.txt | 0 doc/{src => txt}/fix_nve_asphere.txt | 0 doc/{src => txt}/fix_nve_asphere_noforce.txt | 0 doc/{src => txt}/fix_nve_awpmd.txt | 0 doc/{src => txt}/fix_nve_body.txt | 0 doc/{src => txt}/fix_nve_dot.txt | 0 doc/{src => txt}/fix_nve_dotc_langevin.txt | 0 doc/{src => txt}/fix_nve_eff.txt | 0 doc/{src => txt}/fix_nve_limit.txt | 0 doc/{src => txt}/fix_nve_line.txt | 0 doc/{src => txt}/fix_nve_manifold_rattle.txt | 0 doc/{src => txt}/fix_nve_noforce.txt | 0 doc/{src => txt}/fix_nve_sphere.txt | 0 doc/{src => txt}/fix_nve_spin.txt | 0 doc/{src => txt}/fix_nve_tri.txt | 0 doc/{src => txt}/fix_nvk.txt | 0 doc/{src => txt}/fix_nvt_asphere.txt | 0 doc/{src => txt}/fix_nvt_body.txt | 0 doc/{src => txt}/fix_nvt_manifold_rattle.txt | 0 doc/{src => txt}/fix_nvt_sllod.txt | 0 doc/{src => txt}/fix_nvt_sllod_eff.txt | 0 doc/{src => txt}/fix_nvt_sphere.txt | 0 doc/{src => txt}/fix_oneway.txt | 0 doc/{src => txt}/fix_orient.txt | 0 doc/{src => txt}/fix_phonon.txt | 0 doc/{src => txt}/fix_pimd.txt | 0 doc/{src => txt}/fix_planeforce.txt | 0 doc/{src => txt}/fix_plumed.txt | 0 doc/{src => txt}/fix_poems.txt | 0 doc/{src => txt}/fix_pour.txt | 0 doc/{src => txt}/fix_precession_spin.txt | 0 doc/{src => txt}/fix_press_berendsen.txt | 0 doc/{src => txt}/fix_print.txt | 0 doc/{src => txt}/fix_property_atom.txt | 0 doc/{src => txt}/fix_python_invoke.txt | 0 doc/{src => txt}/fix_python_move.txt | 0 doc/{src => txt}/fix_qbmsst.txt | 0 doc/{src => txt}/fix_qeq.txt | 0 doc/{src => txt}/fix_qeq_comb.txt | 0 doc/{src => txt}/fix_qeq_reax.txt | 0 doc/{src => txt}/fix_qmmm.txt | 0 doc/{src => txt}/fix_qtb.txt | 0 doc/{src => txt}/fix_reaxc_bonds.txt | 0 doc/{src => txt}/fix_reaxc_species.txt | 0 doc/{src => txt}/fix_recenter.txt | 0 doc/{src => txt}/fix_restrain.txt | 0 doc/{src => txt}/fix_rhok.txt | 0 doc/{src => txt}/fix_rigid.txt | 0 doc/{src => txt}/fix_rigid_meso.txt | 0 doc/{src => txt}/fix_rx.txt | 0 doc/{src => txt}/fix_saed_vtk.txt | 0 doc/{src => txt}/fix_setforce.txt | 0 doc/{src => txt}/fix_shake.txt | 0 doc/{src => txt}/fix_shardlow.txt | 0 doc/{src => txt}/fix_smd.txt | 0 doc/{src => txt}/fix_smd_adjust_dt.txt | 0 doc/{src => txt}/fix_smd_integrate_tlsph.txt | 0 doc/{src => txt}/fix_smd_integrate_ulsph.txt | 0 .../fix_smd_move_triangulated_surface.txt | 0 doc/{src => txt}/fix_smd_setvel.txt | 0 doc/{src => txt}/fix_smd_wall_surface.txt | 0 doc/{src => txt}/fix_spring.txt | 0 doc/{src => txt}/fix_spring_chunk.txt | 0 doc/{src => txt}/fix_spring_rg.txt | 0 doc/{src => txt}/fix_spring_self.txt | 0 doc/{src => txt}/fix_srd.txt | 0 doc/{src => txt}/fix_store_force.txt | 0 doc/{src => txt}/fix_store_state.txt | 0 doc/{src => txt}/fix_temp_berendsen.txt | 0 doc/{src => txt}/fix_temp_csvr.txt | 0 doc/{src => txt}/fix_temp_rescale.txt | 0 doc/{src => txt}/fix_temp_rescale_eff.txt | 0 doc/{src => txt}/fix_tfmc.txt | 0 doc/{src => txt}/fix_thermal_conductivity.txt | 0 doc/{src => txt}/fix_ti_spring.txt | 0 doc/{src => txt}/fix_tmd.txt | 0 doc/{src => txt}/fix_ttm.txt | 0 doc/{src => txt}/fix_tune_kspace.txt | 0 doc/{src => txt}/fix_vector.txt | 0 doc/{src => txt}/fix_viscosity.txt | 0 doc/{src => txt}/fix_viscous.txt | 0 doc/{src => txt}/fix_wall.txt | 0 doc/{src => txt}/fix_wall_body_polygon.txt | 0 doc/{src => txt}/fix_wall_body_polyhedron.txt | 0 doc/{src => txt}/fix_wall_ees.txt | 0 doc/{src => txt}/fix_wall_gran.txt | 0 doc/{src => txt}/fix_wall_gran_region.txt | 0 doc/{src => txt}/fix_wall_piston.txt | 0 doc/{src => txt}/fix_wall_reflect.txt | 0 doc/{src => txt}/fix_wall_region.txt | 0 doc/{src => txt}/fix_wall_srd.txt | 0 doc/{src => txt}/fixes.txt | 0 doc/{src => txt}/group.txt | 0 doc/{src => txt}/group2ndx.txt | 0 doc/{src => txt}/hyper.txt | 0 doc/{src => txt}/if.txt | 0 doc/{src => txt}/improper_class2.txt | 0 doc/{src => txt}/improper_coeff.txt | 0 doc/{src => txt}/improper_cossq.txt | 0 doc/{src => txt}/improper_cvff.txt | 0 doc/{src => txt}/improper_distance.txt | 0 doc/{src => txt}/improper_distharm.txt | 0 doc/{src => txt}/improper_fourier.txt | 0 doc/{src => txt}/improper_harmonic.txt | 0 doc/{src => txt}/improper_hybrid.txt | 0 .../improper_inversion_harmonic.txt | 0 doc/{src => txt}/improper_none.txt | 0 doc/{src => txt}/improper_ring.txt | 0 doc/{src => txt}/improper_sqdistharm.txt | 0 doc/{src => txt}/improper_style.txt | 0 doc/{src => txt}/improper_umbrella.txt | 0 doc/{src => txt}/improper_zero.txt | 0 doc/{src => txt}/impropers.txt | 0 doc/{src => txt}/include.txt | 0 doc/{src => txt}/info.txt | 0 doc/{src => txt}/jump.txt | 0 doc/{src => txt}/kim_commands.txt | 0 doc/{src => txt}/kspace_modify.txt | 0 doc/{src => txt}/kspace_style.txt | 0 doc/{src => txt}/label.txt | 0 doc/{src => txt}/lammps.book | 0 doc/{src => txt}/lammps_commands.txt | 0 doc/{src => txt}/lammps_commands_angle.txt | 0 doc/{src => txt}/lammps_commands_atc.txt | 0 doc/{src => txt}/lammps_commands_bond.txt | 0 doc/{src => txt}/lammps_commands_compute.txt | 0 doc/{src => txt}/lammps_commands_dihedral.txt | 0 doc/{src => txt}/lammps_commands_fix.txt | 0 doc/{src => txt}/lammps_commands_improper.txt | 0 doc/{src => txt}/lammps_commands_kspace.txt | 0 doc/{src => txt}/lammps_commands_pair.txt | 0 doc/{src => txt}/lattice.txt | 0 doc/{src => txt}/log.txt | 0 doc/{src => txt}/mass.txt | 0 doc/{src => txt}/message.txt | 0 doc/{src => txt}/min_modify.txt | 0 doc/{src => txt}/min_spin.txt | 0 doc/{src => txt}/min_style.txt | 0 doc/{src => txt}/minimize.txt | 0 doc/{src => txt}/molecule.txt | 0 doc/{src => txt}/neb.txt | 0 doc/{src => txt}/neb_spin.txt | 0 doc/{src => txt}/neigh_modify.txt | 0 doc/{src => txt}/neighbor.txt | 0 doc/{src => txt}/newton.txt | 0 doc/{src => txt}/next.txt | 0 doc/{src => txt}/package.txt | 0 doc/{src => txt}/pair_adp.txt | 0 doc/{src => txt}/pair_agni.txt | 0 doc/{src => txt}/pair_airebo.txt | 0 doc/{src => txt}/pair_atm.txt | 0 doc/{src => txt}/pair_awpmd.txt | 0 doc/{src => txt}/pair_beck.txt | 0 doc/{src => txt}/pair_body_nparticle.txt | 0 .../pair_body_rounded_polygon.txt | 0 .../pair_body_rounded_polyhedron.txt | 0 doc/{src => txt}/pair_bop.txt | 0 doc/{src => txt}/pair_born.txt | 0 doc/{src => txt}/pair_brownian.txt | 0 doc/{src => txt}/pair_buck.txt | 0 doc/{src => txt}/pair_buck6d_coul_gauss.txt | 0 doc/{src => txt}/pair_buck_long.txt | 0 doc/{src => txt}/pair_charmm.txt | 0 doc/{src => txt}/pair_class2.txt | 0 doc/{src => txt}/pair_coeff.txt | 0 doc/{src => txt}/pair_colloid.txt | 0 doc/{src => txt}/pair_comb.txt | 0 doc/{src => txt}/pair_cosine_squared.txt | 0 doc/{src => txt}/pair_coul.txt | 0 doc/{src => txt}/pair_coul_diel.txt | 0 doc/{src => txt}/pair_coul_shield.txt | 0 doc/{src => txt}/pair_cs.txt | 0 doc/{src => txt}/pair_dipole.txt | 0 doc/{src => txt}/pair_dpd.txt | 0 doc/{src => txt}/pair_dpd_fdt.txt | 0 doc/{src => txt}/pair_drip.txt | 0 doc/{src => txt}/pair_dsmc.txt | 0 doc/{src => txt}/pair_e3b.txt | 0 doc/{src => txt}/pair_eam.txt | 0 doc/{src => txt}/pair_edip.txt | 0 doc/{src => txt}/pair_eff.txt | 0 doc/{src => txt}/pair_eim.txt | 0 doc/{src => txt}/pair_exp6_rx.txt | 0 doc/{src => txt}/pair_extep.txt | 0 doc/{src => txt}/pair_fep_soft.txt | 0 doc/{src => txt}/pair_gauss.txt | 0 doc/{src => txt}/pair_gayberne.txt | 0 doc/{src => txt}/pair_gran.txt | 0 doc/{src => txt}/pair_granular.txt | 0 doc/{src => txt}/pair_gromacs.txt | 0 doc/{src => txt}/pair_gw.txt | 0 doc/{src => txt}/pair_hbond_dreiding.txt | 0 doc/{src => txt}/pair_hybrid.txt | 0 doc/{src => txt}/pair_ilp_graphene_hbn.txt | 0 doc/{src => txt}/pair_kim.txt | 0 .../pair_kolmogorov_crespi_full.txt | 0 doc/{src => txt}/pair_kolmogorov_crespi_z.txt | 0 doc/{src => txt}/pair_lcbop.txt | 0 doc/{src => txt}/pair_lebedeva_z.txt | 0 doc/{src => txt}/pair_line_lj.txt | 0 doc/{src => txt}/pair_list.txt | 0 doc/{src => txt}/pair_lj.txt | 0 doc/{src => txt}/pair_lj96.txt | 0 doc/{src => txt}/pair_lj_cubic.txt | 0 doc/{src => txt}/pair_lj_expand.txt | 0 doc/{src => txt}/pair_lj_long.txt | 0 doc/{src => txt}/pair_lj_smooth.txt | 0 doc/{src => txt}/pair_lj_smooth_linear.txt | 0 .../pair_lj_switch3_coulgauss.txt | 0 doc/{src => txt}/pair_local_density.txt | 0 doc/{src => txt}/pair_lubricate.txt | 0 doc/{src => txt}/pair_lubricateU.txt | 0 doc/{src => txt}/pair_mdf.txt | 0 doc/{src => txt}/pair_meam_spline.txt | 0 doc/{src => txt}/pair_meam_sw_spline.txt | 0 doc/{src => txt}/pair_meamc.txt | 0 doc/{src => txt}/pair_meso.txt | 0 doc/{src => txt}/pair_mgpt.txt | 0 doc/{src => txt}/pair_mie.txt | 0 .../pair_mm3_switch3_coulgauss.txt | 0 doc/{src => txt}/pair_modify.txt | 0 doc/{src => txt}/pair_momb.txt | 0 doc/{src => txt}/pair_morse.txt | 0 doc/{src => txt}/pair_multi_lucy.txt | 0 doc/{src => txt}/pair_multi_lucy_rx.txt | 0 doc/{src => txt}/pair_nb3b_harmonic.txt | 0 doc/{src => txt}/pair_nm.txt | 0 doc/{src => txt}/pair_none.txt | 0 doc/{src => txt}/pair_oxdna.txt | 0 doc/{src => txt}/pair_oxdna2.txt | 0 doc/{src => txt}/pair_peri.txt | 0 doc/{src => txt}/pair_polymorphic.txt | 0 doc/{src => txt}/pair_python.txt | 0 doc/{src => txt}/pair_quip.txt | 0 doc/{src => txt}/pair_reaxc.txt | 0 doc/{src => txt}/pair_resquared.txt | 0 doc/{src => txt}/pair_sdk.txt | 0 .../pair_sdpd_taitwater_isothermal.txt | 0 doc/{src => txt}/pair_smd_hertz.txt | 0 doc/{src => txt}/pair_smd_tlsph.txt | 0 .../pair_smd_triangulated_surface.txt | 0 doc/{src => txt}/pair_smd_ulsph.txt | 0 doc/{src => txt}/pair_smtbq.txt | 0 doc/{src => txt}/pair_snap.txt | 0 doc/{src => txt}/pair_soft.txt | 0 doc/{src => txt}/pair_sph_heatconduction.txt | 0 doc/{src => txt}/pair_sph_idealgas.txt | 0 doc/{src => txt}/pair_sph_lj.txt | 0 doc/{src => txt}/pair_sph_rhosum.txt | 0 doc/{src => txt}/pair_sph_taitwater.txt | 0 .../pair_sph_taitwater_morris.txt | 0 doc/{src => txt}/pair_spin_dipole.txt | 0 doc/{src => txt}/pair_spin_dmi.txt | 0 doc/{src => txt}/pair_spin_exchange.txt | 0 doc/{src => txt}/pair_spin_magelec.txt | 0 doc/{src => txt}/pair_spin_neel.txt | 0 doc/{src => txt}/pair_srp.txt | 0 doc/{src => txt}/pair_style.txt | 0 doc/{src => txt}/pair_sw.txt | 0 doc/{src => txt}/pair_table.txt | 0 doc/{src => txt}/pair_table_rx.txt | 0 doc/{src => txt}/pair_tersoff.txt | 0 doc/{src => txt}/pair_tersoff_mod.txt | 0 doc/{src => txt}/pair_tersoff_zbl.txt | 0 doc/{src => txt}/pair_thole.txt | 0 doc/{src => txt}/pair_tri_lj.txt | 0 doc/{src => txt}/pair_ufm.txt | 0 doc/{src => txt}/pair_vashishta.txt | 0 doc/{src => txt}/pair_write.txt | 0 doc/{src => txt}/pair_yukawa.txt | 0 doc/{src => txt}/pair_yukawa_colloid.txt | 0 doc/{src => txt}/pair_zbl.txt | 0 doc/{src => txt}/pair_zero.txt | 0 doc/{src => txt}/pairs.txt | 0 doc/{src => txt}/partition.txt | 0 doc/{src => txt}/prd.txt | 0 doc/{src => txt}/print.txt | 0 doc/{src => txt}/processors.txt | 0 doc/{src => txt}/python.txt | 0 doc/{src => txt}/quit.txt | 0 doc/{src => txt}/read_data.txt | 0 doc/{src => txt}/read_dump.txt | 0 doc/{src => txt}/read_restart.txt | 0 doc/{src => txt}/region.txt | 0 doc/{src => txt}/replicate.txt | 0 doc/{src => txt}/rerun.txt | 0 doc/{src => txt}/reset_ids.txt | 0 doc/{src => txt}/reset_timestep.txt | 0 doc/{src => txt}/restart.txt | 0 doc/{src => txt}/run.txt | 0 doc/{src => txt}/run_style.txt | 0 doc/{src => txt}/server.txt | 0 doc/{src => txt}/server_mc.txt | 0 doc/{src => txt}/server_md.txt | 0 doc/{src => txt}/set.txt | 0 doc/{src => txt}/shell.txt | 0 doc/{src => txt}/special_bonds.txt | 0 doc/{src => txt}/suffix.txt | 0 doc/{src => txt}/tad.txt | 0 doc/{src => txt}/temper.txt | 0 doc/{src => txt}/temper_grem.txt | 0 doc/{src => txt}/temper_npt.txt | 0 doc/{src => txt}/thermo.txt | 0 doc/{src => txt}/thermo_modify.txt | 0 doc/{src => txt}/thermo_style.txt | 0 doc/{src => txt}/third_order.txt | 0 doc/{src => txt}/timer.txt | 0 doc/{src => txt}/timestep.txt | 0 doc/{src => txt}/uncompute.txt | 0 doc/{src => txt}/undump.txt | 0 doc/{src => txt}/unfix.txt | 0 doc/{src => txt}/units.txt | 0 doc/{src => txt}/variable.txt | 0 doc/{src => txt}/velocity.txt | 0 doc/{src => txt}/write_coeff.txt | 0 doc/{src => txt}/write_data.txt | 0 doc/{src => txt}/write_dump.txt | 0 doc/{src => txt}/write_restart.txt | 0 1525 files changed, 12 insertions(+), 13 deletions(-) rename doc/{rst => src}/.gitignore (100%) rename doc/{rst => src}/Build.rst (100%) rename doc/{rst => src}/Build_basics.rst (100%) rename doc/{rst => src}/Build_cmake.rst (100%) rename doc/{rst => src}/Build_development.rst (100%) rename doc/{rst => src}/Build_extras.rst (100%) rename doc/{rst => src}/Build_link.rst (100%) rename doc/{rst => src}/Build_make.rst (100%) rename doc/{rst => src}/Build_package.rst (100%) rename doc/{rst => src}/Build_settings.rst (100%) rename doc/{rst => src}/Build_windows.rst (100%) rename doc/{rst => src}/Commands.rst (100%) rename doc/{rst => src}/Commands_all.rst (100%) rename doc/{rst => src}/Commands_bond.rst (100%) rename doc/{rst => src}/Commands_category.rst (100%) rename doc/{rst => src}/Commands_compute.rst (100%) rename doc/{rst => src}/Commands_fix.rst (100%) rename doc/{rst => src}/Commands_input.rst (100%) rename doc/{rst => src}/Commands_kspace.rst (100%) rename doc/{rst => src}/Commands_pair.rst (100%) rename doc/{rst => src}/Commands_parse.rst (100%) rename doc/{rst => src}/Commands_removed.rst (100%) rename doc/{rst => src}/Commands_structure.rst (100%) rename doc/{rst => src}/Errors.rst (100%) rename doc/{rst => src}/Errors_bugs.rst (100%) rename doc/{rst => src}/Errors_common.rst (100%) rename doc/{rst => src}/Errors_messages.rst (100%) rename doc/{rst => src}/Errors_warnings.rst (100%) rename doc/{rst => src}/Examples.rst (100%) rename doc/{rst => src}/Howto.rst (100%) rename doc/{rst => src}/Howto_2d.rst (100%) rename doc/{rst => src}/Howto_barostat.rst (100%) rename doc/{rst => src}/Howto_bash.rst (100%) rename doc/{rst => src}/Howto_bioFF.rst (100%) rename doc/{rst => src}/Howto_body.rst (100%) rename doc/{rst => src}/Howto_chunk.rst (100%) rename doc/{rst => src}/Howto_client_server.rst (100%) rename doc/{rst => src}/Howto_coreshell.rst (100%) rename doc/{rst => src}/Howto_couple.rst (100%) rename doc/{rst => src}/Howto_diffusion.rst (100%) rename doc/{rst => src}/Howto_dispersion.rst (100%) rename doc/{rst => src}/Howto_drude.rst (100%) rename doc/{rst => src}/Howto_drude2.rst (100%) rename doc/{rst => src}/Howto_elastic.rst (100%) rename doc/{rst => src}/Howto_github.rst (100%) rename doc/{rst => src}/Howto_granular.rst (100%) rename doc/{rst => src}/Howto_kappa.rst (100%) rename doc/{rst => src}/Howto_library.rst (100%) rename doc/{rst => src}/Howto_manifold.rst (100%) rename doc/{rst => src}/Howto_multiple.rst (100%) rename doc/{rst => src}/Howto_nemd.rst (100%) rename doc/{rst => src}/Howto_output.rst (100%) rename doc/{rst => src}/Howto_polarizable.rst (100%) rename doc/{rst => src}/Howto_pylammps.rst (100%) rename doc/{rst => src}/Howto_replica.rst (100%) rename doc/{rst => src}/Howto_restart.rst (100%) rename doc/{rst => src}/Howto_spc.rst (100%) rename doc/{rst => src}/Howto_spherical.rst (100%) rename doc/{rst => src}/Howto_spins.rst (100%) rename doc/{rst => src}/Howto_temperature.rst (100%) rename doc/{rst => src}/Howto_thermostat.rst (100%) rename doc/{rst => src}/Howto_tip3p.rst (100%) rename doc/{rst => src}/Howto_tip4p.rst (100%) rename doc/{rst => src}/Howto_triclinic.rst (100%) rename doc/{rst => src}/Howto_viscosity.rst (100%) rename doc/{rst => src}/Howto_viz.rst (100%) rename doc/{rst => src}/Howto_walls.rst (100%) rename doc/{rst => src}/Install.rst (100%) rename doc/{rst => src}/Install_git.rst (100%) rename doc/{rst => src}/Install_linux.rst (100%) rename doc/{rst => src}/Install_mac.rst (100%) rename doc/{rst => src}/Install_patch.rst (100%) rename doc/{rst => src}/Install_svn.rst (100%) rename doc/{rst => src}/Install_tarball.rst (100%) rename doc/{rst => src}/Install_windows.rst (100%) rename doc/{rst => src}/Intro.rst (100%) rename doc/{rst => src}/Intro_authors.rst (100%) rename doc/{rst => src}/Intro_features.rst (100%) rename doc/{rst => src}/Intro_nonfeatures.rst (100%) rename doc/{rst => src}/Intro_opensource.rst (100%) rename doc/{rst => src}/Intro_overview.rst (100%) rename doc/{rst => src}/Intro_website.rst (100%) rename doc/{rst => src}/Manual.rst (100%) rename doc/{rst => src}/Manual_build.rst (100%) rename doc/{rst => src}/Manual_version.rst (100%) rename doc/{rst => src}/Modify.rst (100%) rename doc/{rst => src}/Modify_atom.rst (100%) rename doc/{rst => src}/Modify_body.rst (100%) rename doc/{rst => src}/Modify_bond.rst (100%) rename doc/{rst => src}/Modify_command.rst (100%) rename doc/{rst => src}/Modify_compute.rst (100%) rename doc/{rst => src}/Modify_contribute.rst (100%) rename doc/{rst => src}/Modify_dump.rst (100%) rename doc/{rst => src}/Modify_fix.rst (100%) rename doc/{rst => src}/Modify_kspace.rst (100%) rename doc/{rst => src}/Modify_min.rst (100%) rename doc/{rst => src}/Modify_overview.rst (100%) rename doc/{rst => src}/Modify_pair.rst (100%) rename doc/{rst => src}/Modify_region.rst (100%) rename doc/{rst => src}/Modify_thermo.rst (100%) rename doc/{rst => src}/Modify_variable.rst (100%) rename doc/{rst => src}/Packages.rst (100%) rename doc/{rst => src}/Packages_details.rst (100%) rename doc/{rst => src}/Packages_standard.rst (100%) rename doc/{rst => src}/Packages_user.rst (100%) rename doc/{rst => src}/Python_call.rst (100%) rename doc/{rst => src}/Python_examples.rst (100%) rename doc/{rst => src}/Python_head.rst (100%) rename doc/{rst => src}/Python_install.rst (100%) rename doc/{rst => src}/Python_library.rst (100%) rename doc/{rst => src}/Python_mpi.rst (100%) rename doc/{rst => src}/Python_overview.rst (100%) rename doc/{rst => src}/Python_pylammps.rst (100%) rename doc/{rst => src}/Python_run.rst (100%) rename doc/{rst => src}/Python_shlib.rst (100%) rename doc/{rst => src}/Python_test.rst (100%) rename doc/{rst => src}/Run_basics.rst (100%) rename doc/{rst => src}/Run_head.rst (100%) rename doc/{rst => src}/Run_options.rst (100%) rename doc/{rst => src}/Run_output.rst (100%) rename doc/{rst => src}/Run_windows.rst (100%) rename doc/{rst => src}/Speed.rst (100%) rename doc/{rst => src}/Speed_bench.rst (100%) rename doc/{rst => src}/Speed_compare.rst (100%) rename doc/{rst => src}/Speed_gpu.rst (100%) rename doc/{rst => src}/Speed_intel.rst (100%) rename doc/{rst => src}/Speed_kokkos.rst (100%) rename doc/{rst => src}/Speed_measure.rst (100%) rename doc/{rst => src}/Speed_omp.rst (100%) rename doc/{rst => src}/Speed_opt.rst (100%) rename doc/{rst => src}/Speed_packages.rst (100%) rename doc/{rst => src}/Speed_tips.rst (100%) rename doc/{rst => src}/Tools.rst (100%) rename doc/{rst => src}/angle_charmm.rst (100%) rename doc/{rst => src}/angle_class2.rst (100%) rename doc/{rst => src}/angle_coeff.rst (100%) rename doc/{rst => src}/angle_cosine.rst (100%) rename doc/{rst => src}/angle_cosine_buck6d.rst (100%) rename doc/{rst => src}/angle_cosine_delta.rst (100%) rename doc/{rst => src}/angle_cosine_periodic.rst (100%) rename doc/{rst => src}/angle_cosine_shift.rst (100%) rename doc/{rst => src}/angle_cosine_shift_exp.rst (100%) rename doc/{rst => src}/angle_cosine_squared.rst (100%) rename doc/{rst => src}/angle_cross.rst (100%) rename doc/{rst => src}/angle_dipole.rst (100%) rename doc/{rst => src}/angle_fourier.rst (100%) rename doc/{rst => src}/angle_fourier_simple.rst (100%) rename doc/{rst => src}/angle_harmonic.rst (100%) rename doc/{rst => src}/angle_hybrid.rst (100%) rename doc/{rst => src}/angle_mm3.rst (100%) rename doc/{rst => src}/angle_none.rst (100%) rename doc/{rst => src}/angle_quartic.rst (100%) rename doc/{rst => src}/angle_sdk.rst (100%) rename doc/{rst => src}/angle_style.rst (100%) rename doc/{rst => src}/angle_table.rst (100%) rename doc/{rst => src}/angle_zero.rst (100%) rename doc/{rst => src}/angles.rst (100%) rename doc/{rst => src}/atom_modify.rst (100%) rename doc/{rst => src}/atom_style.rst (100%) rename doc/{rst => src}/balance.rst (100%) rename doc/{rst => src}/bond_class2.rst (100%) rename doc/{rst => src}/bond_coeff.rst (100%) rename doc/{rst => src}/bond_fene.rst (100%) rename doc/{rst => src}/bond_fene_expand.rst (100%) rename doc/{rst => src}/bond_gromos.rst (100%) rename doc/{rst => src}/bond_harmonic.rst (100%) rename doc/{rst => src}/bond_harmonic_shift.rst (100%) rename doc/{rst => src}/bond_harmonic_shift_cut.rst (100%) rename doc/{rst => src}/bond_hybrid.rst (100%) rename doc/{rst => src}/bond_mm3.rst (100%) rename doc/{rst => src}/bond_morse.rst (100%) rename doc/{rst => src}/bond_none.rst (100%) rename doc/{rst => src}/bond_nonlinear.rst (100%) rename doc/{rst => src}/bond_oxdna.rst (100%) rename doc/{rst => src}/bond_quartic.rst (100%) rename doc/{rst => src}/bond_style.rst (100%) rename doc/{rst => src}/bond_table.rst (100%) rename doc/{rst => src}/bond_write.rst (100%) rename doc/{rst => src}/bond_zero.rst (100%) rename doc/{rst => src}/bonds.rst (100%) rename doc/{rst => src}/boundary.rst (100%) rename doc/{rst => src}/box.rst (100%) rename doc/{rst => src}/change_box.rst (100%) rename doc/{rst => src}/clear.rst (100%) rename doc/{rst => src}/comm_modify.rst (100%) rename doc/{rst => src}/comm_style.rst (100%) rename doc/{rst => src}/commands_list.rst (100%) rename doc/{rst => src}/compute.rst (100%) rename doc/{rst => src}/compute_ackland_atom.rst (100%) rename doc/{rst => src}/compute_adf.rst (100%) rename doc/{rst => src}/compute_angle.rst (100%) rename doc/{rst => src}/compute_angle_local.rst (100%) rename doc/{rst => src}/compute_angmom_chunk.rst (100%) rename doc/{rst => src}/compute_basal_atom.rst (100%) rename doc/{rst => src}/compute_body_local.rst (100%) rename doc/{rst => src}/compute_bond.rst (100%) rename doc/{rst => src}/compute_bond_local.rst (100%) rename doc/{rst => src}/compute_centro_atom.rst (100%) rename doc/{rst => src}/compute_chunk_atom.rst (100%) rename doc/{rst => src}/compute_chunk_spread_atom.rst (100%) rename doc/{rst => src}/compute_cluster_atom.rst (100%) rename doc/{rst => src}/compute_cna_atom.rst (100%) rename doc/{rst => src}/compute_cnp_atom.rst (100%) rename doc/{rst => src}/compute_com.rst (100%) rename doc/{rst => src}/compute_com_chunk.rst (100%) rename doc/{rst => src}/compute_contact_atom.rst (100%) rename doc/{rst => src}/compute_coord_atom.rst (100%) rename doc/{rst => src}/compute_damage_atom.rst (100%) rename doc/{rst => src}/compute_dihedral.rst (100%) rename doc/{rst => src}/compute_dihedral_local.rst (100%) rename doc/{rst => src}/compute_dilatation_atom.rst (100%) rename doc/{rst => src}/compute_dipole_chunk.rst (100%) rename doc/{rst => src}/compute_displace_atom.rst (100%) rename doc/{rst => src}/compute_dpd.rst (100%) rename doc/{rst => src}/compute_dpd_atom.rst (100%) rename doc/{rst => src}/compute_edpd_temp_atom.rst (100%) rename doc/{rst => src}/compute_entropy_atom.rst (100%) rename doc/{rst => src}/compute_erotate_asphere.rst (100%) rename doc/{rst => src}/compute_erotate_rigid.rst (100%) rename doc/{rst => src}/compute_erotate_sphere.rst (100%) rename doc/{rst => src}/compute_erotate_sphere_atom.rst (100%) rename doc/{rst => src}/compute_event_displace.rst (100%) rename doc/{rst => src}/compute_fep.rst (100%) rename doc/{rst => src}/compute_global_atom.rst (100%) rename doc/{rst => src}/compute_group_group.rst (100%) rename doc/{rst => src}/compute_gyration.rst (100%) rename doc/{rst => src}/compute_gyration_chunk.rst (100%) rename doc/{rst => src}/compute_gyration_shape.rst (100%) rename doc/{rst => src}/compute_heat_flux.rst (100%) rename doc/{rst => src}/compute_hexorder_atom.rst (100%) rename doc/{rst => src}/compute_hma.rst (100%) rename doc/{rst => src}/compute_improper.rst (100%) rename doc/{rst => src}/compute_improper_local.rst (100%) rename doc/{rst => src}/compute_inertia_chunk.rst (100%) rename doc/{rst => src}/compute_ke.rst (100%) rename doc/{rst => src}/compute_ke_atom.rst (100%) rename doc/{rst => src}/compute_ke_atom_eff.rst (100%) rename doc/{rst => src}/compute_ke_eff.rst (100%) rename doc/{rst => src}/compute_ke_rigid.rst (100%) rename doc/{rst => src}/compute_meso_e_atom.rst (100%) rename doc/{rst => src}/compute_meso_rho_atom.rst (100%) rename doc/{rst => src}/compute_meso_t_atom.rst (100%) rename doc/{rst => src}/compute_modify.rst (100%) rename doc/{rst => src}/compute_momentum.rst (100%) rename doc/{rst => src}/compute_msd.rst (100%) rename doc/{rst => src}/compute_msd_chunk.rst (100%) rename doc/{rst => src}/compute_msd_nongauss.rst (100%) rename doc/{rst => src}/compute_omega_chunk.rst (100%) rename doc/{rst => src}/compute_orientorder_atom.rst (100%) rename doc/{rst => src}/compute_pair.rst (100%) rename doc/{rst => src}/compute_pair_local.rst (100%) rename doc/{rst => src}/compute_pe.rst (100%) rename doc/{rst => src}/compute_pe_atom.rst (100%) rename doc/{rst => src}/compute_plasticity_atom.rst (100%) rename doc/{rst => src}/compute_pressure.rst (100%) rename doc/{rst => src}/compute_pressure_cylinder.rst (100%) rename doc/{rst => src}/compute_pressure_uef.rst (100%) rename doc/{rst => src}/compute_property_atom.rst (100%) rename doc/{rst => src}/compute_property_chunk.rst (100%) rename doc/{rst => src}/compute_property_local.rst (100%) rename doc/{rst => src}/compute_ptm_atom.rst (100%) rename doc/{rst => src}/compute_rdf.rst (100%) rename doc/{rst => src}/compute_reduce.rst (100%) rename doc/{rst => src}/compute_reduce_chunk.rst (100%) rename doc/{rst => src}/compute_rigid_local.rst (100%) rename doc/{rst => src}/compute_saed.rst (100%) rename doc/{rst => src}/compute_slice.rst (100%) rename doc/{rst => src}/compute_smd_contact_radius.rst (100%) rename doc/{rst => src}/compute_smd_damage.rst (100%) rename doc/{rst => src}/compute_smd_hourglass_error.rst (100%) rename doc/{rst => src}/compute_smd_internal_energy.rst (100%) rename doc/{rst => src}/compute_smd_plastic_strain.rst (100%) rename doc/{rst => src}/compute_smd_plastic_strain_rate.rst (100%) rename doc/{rst => src}/compute_smd_rho.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_defgrad.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_dt.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_num_neighs.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_shape.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_strain.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_strain_rate.rst (100%) rename doc/{rst => src}/compute_smd_tlsph_stress.rst (100%) rename doc/{rst => src}/compute_smd_triangle_vertices.rst (100%) rename doc/{rst => src}/compute_smd_ulsph_num_neighs.rst (100%) rename doc/{rst => src}/compute_smd_ulsph_strain.rst (100%) rename doc/{rst => src}/compute_smd_ulsph_strain_rate.rst (100%) rename doc/{rst => src}/compute_smd_ulsph_stress.rst (100%) rename doc/{rst => src}/compute_smd_vol.rst (100%) rename doc/{rst => src}/compute_sna_atom.rst (100%) rename doc/{rst => src}/compute_spin.rst (100%) rename doc/{rst => src}/compute_stress_atom.rst (100%) rename doc/{rst => src}/compute_stress_mop.rst (100%) rename doc/{rst => src}/compute_tally.rst (100%) rename doc/{rst => src}/compute_tdpd_cc_atom.rst (100%) rename doc/{rst => src}/compute_temp.rst (100%) rename doc/{rst => src}/compute_temp_asphere.rst (100%) rename doc/{rst => src}/compute_temp_body.rst (100%) rename doc/{rst => src}/compute_temp_chunk.rst (100%) rename doc/{rst => src}/compute_temp_com.rst (100%) rename doc/{rst => src}/compute_temp_cs.rst (100%) rename doc/{rst => src}/compute_temp_deform.rst (100%) rename doc/{rst => src}/compute_temp_deform_eff.rst (100%) rename doc/{rst => src}/compute_temp_drude.rst (100%) rename doc/{rst => src}/compute_temp_eff.rst (100%) rename doc/{rst => src}/compute_temp_partial.rst (100%) rename doc/{rst => src}/compute_temp_profile.rst (100%) rename doc/{rst => src}/compute_temp_ramp.rst (100%) rename doc/{rst => src}/compute_temp_region.rst (100%) rename doc/{rst => src}/compute_temp_region_eff.rst (100%) rename doc/{rst => src}/compute_temp_rotate.rst (100%) rename doc/{rst => src}/compute_temp_sphere.rst (100%) rename doc/{rst => src}/compute_temp_uef.rst (100%) rename doc/{rst => src}/compute_ti.rst (100%) rename doc/{rst => src}/compute_torque_chunk.rst (100%) rename doc/{rst => src}/compute_vacf.rst (100%) rename doc/{rst => src}/compute_vcm_chunk.rst (100%) rename doc/{rst => src}/compute_voronoi_atom.rst (100%) rename doc/{rst => src}/compute_xrd.rst (100%) rename doc/{rst => src}/computes.rst (100%) rename doc/{rst => src}/create_atoms.rst (100%) rename doc/{rst => src}/create_bonds.rst (100%) rename doc/{rst => src}/create_box.rst (100%) rename doc/{rst => src}/delete_atoms.rst (100%) rename doc/{rst => src}/delete_bonds.rst (100%) rename doc/{rst => src}/dielectric.rst (100%) rename doc/{rst => src}/dihedral_charmm.rst (100%) rename doc/{rst => src}/dihedral_class2.rst (100%) rename doc/{rst => src}/dihedral_coeff.rst (100%) rename doc/{rst => src}/dihedral_cosine_shift_exp.rst (100%) rename doc/{rst => src}/dihedral_fourier.rst (100%) rename doc/{rst => src}/dihedral_harmonic.rst (100%) rename doc/{rst => src}/dihedral_helix.rst (100%) rename doc/{rst => src}/dihedral_hybrid.rst (100%) rename doc/{rst => src}/dihedral_multi_harmonic.rst (100%) rename doc/{rst => src}/dihedral_nharmonic.rst (100%) rename doc/{rst => src}/dihedral_none.rst (100%) rename doc/{rst => src}/dihedral_opls.rst (100%) rename doc/{rst => src}/dihedral_quadratic.rst (100%) rename doc/{rst => src}/dihedral_spherical.rst (100%) rename doc/{rst => src}/dihedral_style.rst (100%) rename doc/{rst => src}/dihedral_table.rst (100%) rename doc/{rst => src}/dihedral_table_cut.rst (100%) rename doc/{rst => src}/dihedral_zero.rst (100%) rename doc/{rst => src}/dihedrals.rst (100%) rename doc/{rst => src}/dimension.rst (100%) rename doc/{rst => src}/displace_atoms.rst (100%) rename doc/{rst => src}/dump.rst (100%) rename doc/{rst => src}/dump_adios.rst (100%) rename doc/{rst => src}/dump_cfg_uef.rst (100%) rename doc/{rst => src}/dump_h5md.rst (100%) rename doc/{rst => src}/dump_image.rst (100%) rename doc/{rst => src}/dump_modify.rst (100%) rename doc/{rst => src}/dump_molfile.rst (100%) rename doc/{rst => src}/dump_netcdf.rst (100%) rename doc/{rst => src}/dump_vtk.rst (100%) rename doc/{rst => src}/dynamical_matrix.rst (100%) rename doc/{rst => src}/echo.rst (100%) rename doc/{rst => src}/fix.rst (100%) rename doc/{rst => src}/fix_adapt.rst (100%) rename doc/{rst => src}/fix_adapt_fep.rst (100%) rename doc/{rst => src}/fix_addforce.rst (100%) rename doc/{rst => src}/fix_addtorque.rst (100%) rename doc/{rst => src}/fix_append_atoms.rst (100%) rename doc/{rst => src}/fix_atc.rst (100%) rename doc/{rst => src}/fix_atom_swap.rst (100%) rename doc/{rst => src}/fix_ave_atom.rst (100%) rename doc/{rst => src}/fix_ave_chunk.rst (100%) rename doc/{rst => src}/fix_ave_correlate.rst (100%) rename doc/{rst => src}/fix_ave_correlate_long.rst (100%) rename doc/{rst => src}/fix_ave_histo.rst (100%) rename doc/{rst => src}/fix_ave_time.rst (100%) rename doc/{rst => src}/fix_aveforce.rst (100%) rename doc/{rst => src}/fix_balance.rst (100%) rename doc/{rst => src}/fix_bocs.rst (100%) rename doc/{rst => src}/fix_bond_break.rst (100%) rename doc/{rst => src}/fix_bond_create.rst (100%) rename doc/{rst => src}/fix_bond_react.rst (100%) rename doc/{rst => src}/fix_bond_swap.rst (100%) rename doc/{rst => src}/fix_box_relax.rst (100%) rename doc/{rst => src}/fix_client_md.rst (100%) rename doc/{rst => src}/fix_cmap.rst (100%) rename doc/{rst => src}/fix_colvars.rst (100%) rename doc/{rst => src}/fix_controller.rst (100%) rename doc/{rst => src}/fix_deform.rst (100%) rename doc/{rst => src}/fix_deposit.rst (100%) rename doc/{rst => src}/fix_dpd_energy.rst (100%) rename doc/{rst => src}/fix_dpd_source.rst (100%) rename doc/{rst => src}/fix_drag.rst (100%) rename doc/{rst => src}/fix_drude.rst (100%) rename doc/{rst => src}/fix_drude_transform.rst (100%) rename doc/{rst => src}/fix_dt_reset.rst (100%) rename doc/{rst => src}/fix_efield.rst (100%) rename doc/{rst => src}/fix_ehex.rst (100%) rename doc/{rst => src}/fix_electron_stopping.rst (100%) rename doc/{rst => src}/fix_enforce2d.rst (100%) rename doc/{rst => src}/fix_eos_cv.rst (100%) rename doc/{rst => src}/fix_eos_table.rst (100%) rename doc/{rst => src}/fix_eos_table_rx.rst (100%) rename doc/{rst => src}/fix_evaporate.rst (100%) rename doc/{rst => src}/fix_external.rst (100%) rename doc/{rst => src}/fix_ffl.rst (100%) rename doc/{rst => src}/fix_filter_corotate.rst (100%) rename doc/{rst => src}/fix_flow_gauss.rst (100%) rename doc/{rst => src}/fix_freeze.rst (100%) rename doc/{rst => src}/fix_gcmc.rst (100%) rename doc/{rst => src}/fix_gld.rst (100%) rename doc/{rst => src}/fix_gle.rst (100%) rename doc/{rst => src}/fix_gravity.rst (100%) rename doc/{rst => src}/fix_grem.rst (100%) rename doc/{rst => src}/fix_halt.rst (100%) rename doc/{rst => src}/fix_heat.rst (100%) rename doc/{rst => src}/fix_hyper_global.rst (100%) rename doc/{rst => src}/fix_hyper_local.rst (100%) rename doc/{rst => src}/fix_imd.rst (100%) rename doc/{rst => src}/fix_indent.rst (100%) rename doc/{rst => src}/fix_ipi.rst (100%) rename doc/{rst => src}/fix_langevin.rst (100%) rename doc/{rst => src}/fix_langevin_drude.rst (100%) rename doc/{rst => src}/fix_langevin_eff.rst (100%) rename doc/{rst => src}/fix_langevin_spin.rst (100%) rename doc/{rst => src}/fix_latte.rst (100%) rename doc/{rst => src}/fix_lb_fluid.rst (100%) rename doc/{rst => src}/fix_lb_momentum.rst (100%) rename doc/{rst => src}/fix_lb_pc.rst (100%) rename doc/{rst => src}/fix_lb_rigid_pc_sphere.rst (100%) rename doc/{rst => src}/fix_lb_viscous.rst (100%) rename doc/{rst => src}/fix_lineforce.rst (100%) rename doc/{rst => src}/fix_manifoldforce.rst (100%) rename doc/{rst => src}/fix_meso.rst (100%) rename doc/{rst => src}/fix_meso_move.rst (100%) rename doc/{rst => src}/fix_meso_stationary.rst (100%) rename doc/{rst => src}/fix_modify.rst (100%) rename doc/{rst => src}/fix_momentum.rst (100%) rename doc/{rst => src}/fix_move.rst (100%) rename doc/{rst => src}/fix_mscg.rst (100%) rename doc/{rst => src}/fix_msst.rst (100%) rename doc/{rst => src}/fix_mvv_dpd.rst (100%) rename doc/{rst => src}/fix_neb.rst (100%) rename doc/{rst => src}/fix_neb_spin.rst (100%) rename doc/{rst => src}/fix_nh.rst (100%) rename doc/{rst => src}/fix_nh_eff.rst (100%) rename doc/{rst => src}/fix_nh_uef.rst (100%) rename doc/{rst => src}/fix_nph_asphere.rst (100%) rename doc/{rst => src}/fix_nph_body.rst (100%) rename doc/{rst => src}/fix_nph_sphere.rst (100%) rename doc/{rst => src}/fix_nphug.rst (100%) rename doc/{rst => src}/fix_npt_asphere.rst (100%) rename doc/{rst => src}/fix_npt_body.rst (100%) rename doc/{rst => src}/fix_npt_sphere.rst (100%) rename doc/{rst => src}/fix_nve.rst (100%) rename doc/{rst => src}/fix_nve_asphere.rst (100%) rename doc/{rst => src}/fix_nve_asphere_noforce.rst (100%) rename doc/{rst => src}/fix_nve_awpmd.rst (100%) rename doc/{rst => src}/fix_nve_body.rst (100%) rename doc/{rst => src}/fix_nve_dot.rst (100%) rename doc/{rst => src}/fix_nve_dotc_langevin.rst (100%) rename doc/{rst => src}/fix_nve_eff.rst (100%) rename doc/{rst => src}/fix_nve_limit.rst (100%) rename doc/{rst => src}/fix_nve_line.rst (100%) rename doc/{rst => src}/fix_nve_manifold_rattle.rst (100%) rename doc/{rst => src}/fix_nve_noforce.rst (100%) rename doc/{rst => src}/fix_nve_sphere.rst (100%) rename doc/{rst => src}/fix_nve_spin.rst (100%) rename doc/{rst => src}/fix_nve_tri.rst (100%) rename doc/{rst => src}/fix_nvk.rst (100%) rename doc/{rst => src}/fix_nvt_asphere.rst (100%) rename doc/{rst => src}/fix_nvt_body.rst (100%) rename doc/{rst => src}/fix_nvt_manifold_rattle.rst (100%) rename doc/{rst => src}/fix_nvt_sllod.rst (100%) rename doc/{rst => src}/fix_nvt_sllod_eff.rst (100%) rename doc/{rst => src}/fix_nvt_sphere.rst (100%) rename doc/{rst => src}/fix_oneway.rst (100%) rename doc/{rst => src}/fix_orient.rst (100%) rename doc/{rst => src}/fix_phonon.rst (100%) rename doc/{rst => src}/fix_pimd.rst (100%) rename doc/{rst => src}/fix_planeforce.rst (100%) rename doc/{rst => src}/fix_plumed.rst (100%) rename doc/{rst => src}/fix_poems.rst (100%) rename doc/{rst => src}/fix_pour.rst (100%) rename doc/{rst => src}/fix_precession_spin.rst (100%) rename doc/{rst => src}/fix_press_berendsen.rst (100%) rename doc/{rst => src}/fix_print.rst (100%) rename doc/{rst => src}/fix_property_atom.rst (100%) rename doc/{rst => src}/fix_python_invoke.rst (100%) rename doc/{rst => src}/fix_python_move.rst (100%) rename doc/{rst => src}/fix_qbmsst.rst (100%) rename doc/{rst => src}/fix_qeq.rst (100%) rename doc/{rst => src}/fix_qeq_comb.rst (100%) rename doc/{rst => src}/fix_qeq_reax.rst (100%) rename doc/{rst => src}/fix_qmmm.rst (100%) rename doc/{rst => src}/fix_qtb.rst (100%) rename doc/{rst => src}/fix_reaxc_bonds.rst (100%) rename doc/{rst => src}/fix_reaxc_species.rst (100%) rename doc/{rst => src}/fix_recenter.rst (100%) rename doc/{rst => src}/fix_restrain.rst (100%) rename doc/{rst => src}/fix_rhok.rst (100%) rename doc/{rst => src}/fix_rigid.rst (100%) rename doc/{rst => src}/fix_rigid_meso.rst (100%) rename doc/{rst => src}/fix_rx.rst (100%) rename doc/{rst => src}/fix_saed_vtk.rst (100%) rename doc/{rst => src}/fix_setforce.rst (100%) rename doc/{rst => src}/fix_shake.rst (100%) rename doc/{rst => src}/fix_shardlow.rst (100%) rename doc/{rst => src}/fix_smd.rst (100%) rename doc/{rst => src}/fix_smd_adjust_dt.rst (100%) rename doc/{rst => src}/fix_smd_integrate_tlsph.rst (100%) rename doc/{rst => src}/fix_smd_integrate_ulsph.rst (100%) rename doc/{rst => src}/fix_smd_move_triangulated_surface.rst (100%) rename doc/{rst => src}/fix_smd_setvel.rst (100%) rename doc/{rst => src}/fix_smd_wall_surface.rst (100%) rename doc/{rst => src}/fix_spring.rst (100%) rename doc/{rst => src}/fix_spring_chunk.rst (100%) rename doc/{rst => src}/fix_spring_rg.rst (100%) rename doc/{rst => src}/fix_spring_self.rst (100%) rename doc/{rst => src}/fix_srd.rst (100%) rename doc/{rst => src}/fix_store_force.rst (100%) rename doc/{rst => src}/fix_store_state.rst (100%) rename doc/{rst => src}/fix_temp_berendsen.rst (100%) rename doc/{rst => src}/fix_temp_csvr.rst (100%) rename doc/{rst => src}/fix_temp_rescale.rst (100%) rename doc/{rst => src}/fix_temp_rescale_eff.rst (100%) rename doc/{rst => src}/fix_tfmc.rst (100%) rename doc/{rst => src}/fix_thermal_conductivity.rst (100%) rename doc/{rst => src}/fix_ti_spring.rst (100%) rename doc/{rst => src}/fix_tmd.rst (100%) rename doc/{rst => src}/fix_ttm.rst (100%) rename doc/{rst => src}/fix_tune_kspace.rst (100%) rename doc/{rst => src}/fix_vector.rst (100%) rename doc/{rst => src}/fix_viscosity.rst (100%) rename doc/{rst => src}/fix_viscous.rst (100%) rename doc/{rst => src}/fix_wall.rst (100%) rename doc/{rst => src}/fix_wall_body_polygon.rst (100%) rename doc/{rst => src}/fix_wall_body_polyhedron.rst (100%) rename doc/{rst => src}/fix_wall_ees.rst (100%) rename doc/{rst => src}/fix_wall_gran.rst (100%) rename doc/{rst => src}/fix_wall_gran_region.rst (100%) rename doc/{rst => src}/fix_wall_piston.rst (100%) rename doc/{rst => src}/fix_wall_reflect.rst (100%) rename doc/{rst => src}/fix_wall_region.rst (100%) rename doc/{rst => src}/fix_wall_srd.rst (100%) rename doc/{rst => src}/fixes.rst (100%) rename doc/{rst => src}/group.rst (100%) rename doc/{rst => src}/group2ndx.rst (100%) rename doc/{rst => src}/hyper.rst (100%) rename doc/{rst => src}/if.rst (100%) rename doc/{rst => src}/improper_class2.rst (100%) rename doc/{rst => src}/improper_coeff.rst (100%) rename doc/{rst => src}/improper_cossq.rst (100%) rename doc/{rst => src}/improper_cvff.rst (100%) rename doc/{rst => src}/improper_distance.rst (100%) rename doc/{rst => src}/improper_distharm.rst (100%) rename doc/{rst => src}/improper_fourier.rst (100%) rename doc/{rst => src}/improper_harmonic.rst (100%) rename doc/{rst => src}/improper_hybrid.rst (100%) rename doc/{rst => src}/improper_inversion_harmonic.rst (100%) rename doc/{rst => src}/improper_none.rst (100%) rename doc/{rst => src}/improper_ring.rst (100%) rename doc/{rst => src}/improper_sqdistharm.rst (100%) rename doc/{rst => src}/improper_style.rst (100%) rename doc/{rst => src}/improper_umbrella.rst (100%) rename doc/{rst => src}/improper_zero.rst (100%) rename doc/{rst => src}/impropers.rst (100%) rename doc/{rst => src}/include.rst (100%) rename doc/{rst => src}/info.rst (100%) rename doc/{rst => src}/jump.rst (100%) rename doc/{rst => src}/kim_commands.rst (100%) rename doc/{rst => src}/kspace_modify.rst (100%) rename doc/{rst => src}/kspace_style.rst (100%) rename doc/{rst => src}/label.rst (100%) rename doc/{rst => src}/lattice.rst (100%) rename doc/{rst => src}/log.rst (100%) rename doc/{rst => src}/mass.rst (100%) rename doc/{rst => src}/message.rst (100%) rename doc/{rst => src}/min_modify.rst (100%) rename doc/{rst => src}/min_spin.rst (100%) rename doc/{rst => src}/min_style.rst (100%) rename doc/{rst => src}/minimize.rst (100%) rename doc/{rst => src}/molecule.rst (100%) rename doc/{rst => src}/neb.rst (100%) rename doc/{rst => src}/neb_spin.rst (100%) rename doc/{rst => src}/neigh_modify.rst (100%) rename doc/{rst => src}/neighbor.rst (100%) rename doc/{rst => src}/newton.rst (100%) rename doc/{rst => src}/next.rst (100%) rename doc/{rst => src}/package.rst (100%) rename doc/{rst => src}/pair_adp.rst (100%) rename doc/{rst => src}/pair_agni.rst (100%) rename doc/{rst => src}/pair_airebo.rst (100%) rename doc/{rst => src}/pair_atm.rst (100%) rename doc/{rst => src}/pair_awpmd.rst (100%) rename doc/{rst => src}/pair_beck.rst (100%) rename doc/{rst => src}/pair_body_nparticle.rst (100%) rename doc/{rst => src}/pair_body_rounded_polygon.rst (100%) rename doc/{rst => src}/pair_body_rounded_polyhedron.rst (100%) rename doc/{rst => src}/pair_bop.rst (100%) rename doc/{rst => src}/pair_born.rst (100%) rename doc/{rst => src}/pair_brownian.rst (100%) rename doc/{rst => src}/pair_buck.rst (100%) rename doc/{rst => src}/pair_buck6d_coul_gauss.rst (100%) rename doc/{rst => src}/pair_buck_long.rst (100%) rename doc/{rst => src}/pair_charmm.rst (100%) rename doc/{rst => src}/pair_class2.rst (100%) rename doc/{rst => src}/pair_coeff.rst (100%) rename doc/{rst => src}/pair_colloid.rst (100%) rename doc/{rst => src}/pair_comb.rst (100%) rename doc/{rst => src}/pair_cosine_squared.rst (100%) rename doc/{rst => src}/pair_coul.rst (100%) rename doc/{rst => src}/pair_coul_diel.rst (100%) rename doc/{rst => src}/pair_coul_shield.rst (100%) rename doc/{rst => src}/pair_cs.rst (100%) rename doc/{rst => src}/pair_dipole.rst (100%) rename doc/{rst => src}/pair_dpd.rst (100%) rename doc/{rst => src}/pair_dpd_fdt.rst (100%) rename doc/{rst => src}/pair_drip.rst (100%) rename doc/{rst => src}/pair_dsmc.rst (100%) rename doc/{rst => src}/pair_e3b.rst (100%) rename doc/{rst => src}/pair_eam.rst (100%) rename doc/{rst => src}/pair_edip.rst (100%) rename doc/{rst => src}/pair_eff.rst (100%) rename doc/{rst => src}/pair_eim.rst (100%) rename doc/{rst => src}/pair_exp6_rx.rst (100%) rename doc/{rst => src}/pair_extep.rst (100%) rename doc/{rst => src}/pair_fep_soft.rst (100%) rename doc/{rst => src}/pair_gauss.rst (100%) rename doc/{rst => src}/pair_gayberne.rst (100%) rename doc/{rst => src}/pair_gran.rst (100%) rename doc/{rst => src}/pair_granular.rst (100%) rename doc/{rst => src}/pair_gromacs.rst (100%) rename doc/{rst => src}/pair_gw.rst (100%) rename doc/{rst => src}/pair_hbond_dreiding.rst (100%) rename doc/{rst => src}/pair_hybrid.rst (100%) rename doc/{rst => src}/pair_ilp_graphene_hbn.rst (100%) rename doc/{rst => src}/pair_kim.rst (100%) rename doc/{rst => src}/pair_kolmogorov_crespi_full.rst (100%) rename doc/{rst => src}/pair_kolmogorov_crespi_z.rst (100%) rename doc/{rst => src}/pair_lcbop.rst (100%) rename doc/{rst => src}/pair_lebedeva_z.rst (100%) rename doc/{rst => src}/pair_line_lj.rst (100%) rename doc/{rst => src}/pair_list.rst (100%) rename doc/{rst => src}/pair_lj.rst (100%) rename doc/{rst => src}/pair_lj96.rst (100%) rename doc/{rst => src}/pair_lj_cubic.rst (100%) rename doc/{rst => src}/pair_lj_expand.rst (100%) rename doc/{rst => src}/pair_lj_long.rst (100%) rename doc/{rst => src}/pair_lj_smooth.rst (100%) rename doc/{rst => src}/pair_lj_smooth_linear.rst (100%) rename doc/{rst => src}/pair_lj_switch3_coulgauss.rst (100%) rename doc/{rst => src}/pair_local_density.rst (100%) rename doc/{rst => src}/pair_lubricate.rst (100%) rename doc/{rst => src}/pair_lubricateU.rst (100%) rename doc/{rst => src}/pair_mdf.rst (100%) rename doc/{rst => src}/pair_meam_spline.rst (100%) rename doc/{rst => src}/pair_meam_sw_spline.rst (100%) rename doc/{rst => src}/pair_meamc.rst (100%) rename doc/{rst => src}/pair_meso.rst (100%) rename doc/{rst => src}/pair_mgpt.rst (100%) rename doc/{rst => src}/pair_mie.rst (100%) rename doc/{rst => src}/pair_mm3_switch3_coulgauss.rst (100%) rename doc/{rst => src}/pair_modify.rst (100%) rename doc/{rst => src}/pair_momb.rst (100%) rename doc/{rst => src}/pair_morse.rst (100%) rename doc/{rst => src}/pair_multi_lucy.rst (100%) rename doc/{rst => src}/pair_multi_lucy_rx.rst (100%) rename doc/{rst => src}/pair_nb3b_harmonic.rst (100%) rename doc/{rst => src}/pair_nm.rst (100%) rename doc/{rst => src}/pair_none.rst (100%) rename doc/{rst => src}/pair_oxdna.rst (100%) rename doc/{rst => src}/pair_oxdna2.rst (100%) rename doc/{rst => src}/pair_peri.rst (100%) rename doc/{rst => src}/pair_polymorphic.rst (100%) rename doc/{rst => src}/pair_python.rst (100%) rename doc/{rst => src}/pair_quip.rst (100%) rename doc/{rst => src}/pair_reaxc.rst (100%) rename doc/{rst => src}/pair_resquared.rst (100%) rename doc/{rst => src}/pair_sdk.rst (100%) rename doc/{rst => src}/pair_sdpd_taitwater_isothermal.rst (100%) rename doc/{rst => src}/pair_smd_hertz.rst (100%) rename doc/{rst => src}/pair_smd_tlsph.rst (100%) rename doc/{rst => src}/pair_smd_triangulated_surface.rst (100%) rename doc/{rst => src}/pair_smd_ulsph.rst (100%) rename doc/{rst => src}/pair_smtbq.rst (100%) rename doc/{rst => src}/pair_snap.rst (100%) rename doc/{rst => src}/pair_soft.rst (100%) rename doc/{rst => src}/pair_sph_heatconduction.rst (100%) rename doc/{rst => src}/pair_sph_idealgas.rst (100%) rename doc/{rst => src}/pair_sph_lj.rst (100%) rename doc/{rst => src}/pair_sph_rhosum.rst (100%) rename doc/{rst => src}/pair_sph_taitwater.rst (100%) rename doc/{rst => src}/pair_sph_taitwater_morris.rst (100%) rename doc/{rst => src}/pair_spin_dipole.rst (100%) rename doc/{rst => src}/pair_spin_dmi.rst (100%) rename doc/{rst => src}/pair_spin_exchange.rst (100%) rename doc/{rst => src}/pair_spin_magelec.rst (100%) rename doc/{rst => src}/pair_spin_neel.rst (100%) rename doc/{rst => src}/pair_srp.rst (100%) rename doc/{rst => src}/pair_style.rst (100%) rename doc/{rst => src}/pair_sw.rst (100%) rename doc/{rst => src}/pair_table.rst (100%) rename doc/{rst => src}/pair_table_rx.rst (100%) rename doc/{rst => src}/pair_tersoff.rst (100%) rename doc/{rst => src}/pair_tersoff_mod.rst (100%) rename doc/{rst => src}/pair_tersoff_zbl.rst (100%) rename doc/{rst => src}/pair_thole.rst (100%) rename doc/{rst => src}/pair_tri_lj.rst (100%) rename doc/{rst => src}/pair_ufm.rst (100%) rename doc/{rst => src}/pair_vashishta.rst (100%) rename doc/{rst => src}/pair_write.rst (100%) rename doc/{rst => src}/pair_yukawa.rst (100%) rename doc/{rst => src}/pair_yukawa_colloid.rst (100%) rename doc/{rst => src}/pair_zbl.rst (100%) rename doc/{rst => src}/pair_zero.rst (100%) rename doc/{rst => src}/pairs.rst (100%) rename doc/{rst => src}/partition.rst (100%) rename doc/{rst => src}/prd.rst (100%) rename doc/{rst => src}/print.rst (100%) rename doc/{rst => src}/processors.rst (100%) rename doc/{rst => src}/python.rst (100%) rename doc/{rst => src}/quit.rst (100%) rename doc/{rst => src}/read_data.rst (100%) rename doc/{rst => src}/read_dump.rst (100%) rename doc/{rst => src}/read_restart.rst (100%) rename doc/{rst => src}/region.rst (100%) rename doc/{rst => src}/replicate.rst (100%) rename doc/{rst => src}/rerun.rst (100%) rename doc/{rst => src}/reset_ids.rst (100%) rename doc/{rst => src}/reset_timestep.rst (100%) rename doc/{rst => src}/restart.rst (100%) rename doc/{rst => src}/run.rst (100%) rename doc/{rst => src}/run_style.rst (100%) rename doc/{rst => src}/server.rst (100%) rename doc/{rst => src}/server_mc.rst (100%) rename doc/{rst => src}/server_md.rst (100%) rename doc/{rst => src}/set.rst (100%) rename doc/{rst => src}/shell.rst (100%) rename doc/{rst => src}/special_bonds.rst (100%) rename doc/{rst => src}/suffix.rst (100%) rename doc/{rst => src}/tad.rst (100%) rename doc/{rst => src}/temper.rst (100%) rename doc/{rst => src}/temper_grem.rst (100%) rename doc/{rst => src}/temper_npt.rst (100%) rename doc/{rst => src}/thermo.rst (100%) rename doc/{rst => src}/thermo_modify.rst (100%) rename doc/{rst => src}/thermo_style.rst (100%) rename doc/{rst => src}/third_order.rst (100%) rename doc/{rst => src}/timer.rst (100%) rename doc/{rst => src}/timestep.rst (100%) rename doc/{rst => src}/uncompute.rst (100%) rename doc/{rst => src}/undump.rst (100%) rename doc/{rst => src}/unfix.rst (100%) rename doc/{rst => src}/units.rst (100%) rename doc/{rst => src}/variable.rst (100%) rename doc/{rst => src}/velocity.rst (100%) rename doc/{rst => src}/write_coeff.rst (100%) rename doc/{rst => src}/write_data.rst (100%) rename doc/{rst => src}/write_dump.rst (100%) rename doc/{rst => src}/write_restart.rst (100%) rename doc/{src => txt}/Build.txt (100%) rename doc/{src => txt}/Build_basics.txt (100%) rename doc/{src => txt}/Build_cmake.txt (100%) rename doc/{src => txt}/Build_development.txt (100%) rename doc/{src => txt}/Build_extras.txt (100%) rename doc/{src => txt}/Build_link.txt (100%) rename doc/{src => txt}/Build_make.txt (100%) rename doc/{src => txt}/Build_package.txt (100%) rename doc/{src => txt}/Build_settings.txt (100%) rename doc/{src => txt}/Build_windows.txt (100%) rename doc/{src => txt}/Commands.txt (100%) rename doc/{src => txt}/Commands_all.txt (100%) rename doc/{src => txt}/Commands_bond.txt (100%) rename doc/{src => txt}/Commands_category.txt (100%) rename doc/{src => txt}/Commands_compute.txt (100%) rename doc/{src => txt}/Commands_fix.txt (100%) rename doc/{src => txt}/Commands_input.txt (100%) rename doc/{src => txt}/Commands_kspace.txt (100%) rename doc/{src => txt}/Commands_pair.txt (100%) rename doc/{src => txt}/Commands_parse.txt (100%) rename doc/{src => txt}/Commands_removed.txt (100%) rename doc/{src => txt}/Commands_structure.txt (100%) rename doc/{src => txt}/Developer/.gitignore (100%) rename doc/{src => txt}/Developer/classes.fig (100%) rename doc/{src => txt}/Developer/classes.pdf (100%) rename doc/{src => txt}/Developer/developer.tex (100%) rename doc/{src => txt}/Errors.txt (100%) rename doc/{src => txt}/Errors_bugs.txt (100%) rename doc/{src => txt}/Errors_common.txt (100%) rename doc/{src => txt}/Errors_messages.txt (100%) rename doc/{src => txt}/Errors_warnings.txt (100%) rename doc/{src => txt}/Examples.txt (100%) rename doc/{src => txt}/Howto.txt (100%) rename doc/{src => txt}/Howto_2d.txt (100%) rename doc/{src => txt}/Howto_barostat.txt (100%) rename doc/{src => txt}/Howto_bash.txt (100%) rename doc/{src => txt}/Howto_bioFF.txt (100%) rename doc/{src => txt}/Howto_body.txt (100%) rename doc/{src => txt}/Howto_chunk.txt (100%) rename doc/{src => txt}/Howto_client_server.txt (100%) rename doc/{src => txt}/Howto_coreshell.txt (100%) rename doc/{src => txt}/Howto_couple.txt (100%) rename doc/{src => txt}/Howto_diffusion.txt (100%) rename doc/{src => txt}/Howto_dispersion.txt (100%) rename doc/{src => txt}/Howto_drude.txt (100%) rename doc/{src => txt}/Howto_drude2.txt (100%) rename doc/{src => txt}/Howto_elastic.txt (100%) rename doc/{src => txt}/Howto_github.txt (100%) rename doc/{src => txt}/Howto_granular.txt (100%) rename doc/{src => txt}/Howto_kappa.txt (100%) rename doc/{src => txt}/Howto_library.txt (100%) rename doc/{src => txt}/Howto_manifold.txt (100%) rename doc/{src => txt}/Howto_multiple.txt (100%) rename doc/{src => txt}/Howto_nemd.txt (100%) rename doc/{src => txt}/Howto_output.txt (100%) rename doc/{src => txt}/Howto_polarizable.txt (100%) rename doc/{src => txt}/Howto_pylammps.txt (100%) rename doc/{src => txt}/Howto_replica.txt (100%) rename doc/{src => txt}/Howto_restart.txt (100%) rename doc/{src => txt}/Howto_spc.txt (100%) rename doc/{src => txt}/Howto_spherical.txt (100%) rename doc/{src => txt}/Howto_spins.txt (100%) rename doc/{src => txt}/Howto_temperature.txt (100%) rename doc/{src => txt}/Howto_thermostat.txt (100%) rename doc/{src => txt}/Howto_tip3p.txt (100%) rename doc/{src => txt}/Howto_tip4p.txt (100%) rename doc/{src => txt}/Howto_triclinic.txt (100%) rename doc/{src => txt}/Howto_viscosity.txt (100%) rename doc/{src => txt}/Howto_viz.txt (100%) rename doc/{src => txt}/Howto_walls.txt (100%) rename doc/{src => txt}/Install.txt (100%) rename doc/{src => txt}/Install_git.txt (100%) rename doc/{src => txt}/Install_linux.txt (100%) rename doc/{src => txt}/Install_mac.txt (100%) rename doc/{src => txt}/Install_patch.txt (100%) rename doc/{src => txt}/Install_svn.txt (100%) rename doc/{src => txt}/Install_tarball.txt (100%) rename doc/{src => txt}/Install_windows.txt (100%) rename doc/{src => txt}/Intro.txt (100%) rename doc/{src => txt}/Intro_authors.txt (100%) rename doc/{src => txt}/Intro_features.txt (100%) rename doc/{src => txt}/Intro_nonfeatures.txt (100%) rename doc/{src => txt}/Intro_opensource.txt (100%) rename doc/{src => txt}/Intro_overview.txt (100%) rename doc/{src => txt}/Intro_website.txt (100%) rename doc/{src => txt}/Manual.txt (100%) rename doc/{src => txt}/Manual_build.txt (100%) rename doc/{src => txt}/Manual_version.txt (100%) rename doc/{src => txt}/Modify.txt (100%) rename doc/{src => txt}/Modify_atom.txt (100%) rename doc/{src => txt}/Modify_body.txt (100%) rename doc/{src => txt}/Modify_bond.txt (100%) rename doc/{src => txt}/Modify_command.txt (100%) rename doc/{src => txt}/Modify_compute.txt (100%) rename doc/{src => txt}/Modify_contribute.txt (100%) rename doc/{src => txt}/Modify_dump.txt (100%) rename doc/{src => txt}/Modify_fix.txt (100%) rename doc/{src => txt}/Modify_kspace.txt (100%) rename doc/{src => txt}/Modify_min.txt (100%) rename doc/{src => txt}/Modify_overview.txt (100%) rename doc/{src => txt}/Modify_pair.txt (100%) rename doc/{src => txt}/Modify_region.txt (100%) rename doc/{src => txt}/Modify_thermo.txt (100%) rename doc/{src => txt}/Modify_variable.txt (100%) rename doc/{src => txt}/Packages.txt (100%) rename doc/{src => txt}/Packages_details.txt (100%) rename doc/{src => txt}/Packages_standard.txt (100%) rename doc/{src => txt}/Packages_user.txt (100%) rename doc/{src => txt}/Python_call.txt (100%) rename doc/{src => txt}/Python_examples.txt (100%) rename doc/{src => txt}/Python_head.txt (100%) rename doc/{src => txt}/Python_install.txt (100%) rename doc/{src => txt}/Python_library.txt (100%) rename doc/{src => txt}/Python_mpi.txt (100%) rename doc/{src => txt}/Python_overview.txt (100%) rename doc/{src => txt}/Python_pylammps.txt (100%) rename doc/{src => txt}/Python_run.txt (100%) rename doc/{src => txt}/Python_shlib.txt (100%) rename doc/{src => txt}/Python_test.txt (100%) rename doc/{src => txt}/Run_basics.txt (100%) rename doc/{src => txt}/Run_head.txt (100%) rename doc/{src => txt}/Run_options.txt (100%) rename doc/{src => txt}/Run_output.txt (100%) rename doc/{src => txt}/Run_windows.txt (100%) rename doc/{src => txt}/Speed.txt (100%) rename doc/{src => txt}/Speed_bench.txt (100%) rename doc/{src => txt}/Speed_compare.txt (100%) rename doc/{src => txt}/Speed_gpu.txt (100%) rename doc/{src => txt}/Speed_intel.txt (100%) rename doc/{src => txt}/Speed_kokkos.txt (100%) rename doc/{src => txt}/Speed_measure.txt (100%) rename doc/{src => txt}/Speed_omp.txt (100%) rename doc/{src => txt}/Speed_opt.txt (100%) rename doc/{src => txt}/Speed_packages.txt (100%) rename doc/{src => txt}/Speed_tips.txt (100%) rename doc/{src => txt}/Tools.txt (100%) rename doc/{src => txt}/angle_charmm.txt (100%) rename doc/{src => txt}/angle_class2.txt (100%) rename doc/{src => txt}/angle_coeff.txt (100%) rename doc/{src => txt}/angle_cosine.txt (100%) rename doc/{src => txt}/angle_cosine_buck6d.txt (100%) rename doc/{src => txt}/angle_cosine_delta.txt (100%) rename doc/{src => txt}/angle_cosine_periodic.txt (100%) rename doc/{src => txt}/angle_cosine_shift.txt (100%) rename doc/{src => txt}/angle_cosine_shift_exp.txt (100%) rename doc/{src => txt}/angle_cosine_squared.txt (100%) rename doc/{src => txt}/angle_cross.txt (100%) rename doc/{src => txt}/angle_dipole.txt (100%) rename doc/{src => txt}/angle_fourier.txt (100%) rename doc/{src => txt}/angle_fourier_simple.txt (100%) rename doc/{src => txt}/angle_harmonic.txt (100%) rename doc/{src => txt}/angle_hybrid.txt (100%) rename doc/{src => txt}/angle_mm3.txt (100%) rename doc/{src => txt}/angle_none.txt (100%) rename doc/{src => txt}/angle_quartic.txt (100%) rename doc/{src => txt}/angle_sdk.txt (100%) rename doc/{src => txt}/angle_style.txt (100%) rename doc/{src => txt}/angle_table.txt (100%) rename doc/{src => txt}/angle_zero.txt (100%) rename doc/{src => txt}/angles.txt (100%) rename doc/{src => txt}/atom_modify.txt (100%) rename doc/{src => txt}/atom_style.txt (100%) rename doc/{src => txt}/balance.txt (100%) rename doc/{src => txt}/bond_class2.txt (100%) rename doc/{src => txt}/bond_coeff.txt (100%) rename doc/{src => txt}/bond_fene.txt (100%) rename doc/{src => txt}/bond_fene_expand.txt (100%) rename doc/{src => txt}/bond_gromos.txt (100%) rename doc/{src => txt}/bond_harmonic.txt (100%) rename doc/{src => txt}/bond_harmonic_shift.txt (100%) rename doc/{src => txt}/bond_harmonic_shift_cut.txt (100%) rename doc/{src => txt}/bond_hybrid.txt (100%) rename doc/{src => txt}/bond_mm3.txt (100%) rename doc/{src => txt}/bond_morse.txt (100%) rename doc/{src => txt}/bond_none.txt (100%) rename doc/{src => txt}/bond_nonlinear.txt (100%) rename doc/{src => txt}/bond_oxdna.txt (100%) rename doc/{src => txt}/bond_quartic.txt (100%) rename doc/{src => txt}/bond_style.txt (100%) rename doc/{src => txt}/bond_table.txt (100%) rename doc/{src => txt}/bond_write.txt (100%) rename doc/{src => txt}/bond_zero.txt (100%) rename doc/{src => txt}/bonds.txt (100%) rename doc/{src => txt}/boundary.txt (100%) rename doc/{src => txt}/box.txt (100%) rename doc/{src => txt}/change_box.txt (100%) rename doc/{src => txt}/clear.txt (100%) rename doc/{src => txt}/comm_modify.txt (100%) rename doc/{src => txt}/comm_style.txt (100%) rename doc/{src => txt}/commands_list.txt (100%) rename doc/{src => txt}/compute.txt (100%) rename doc/{src => txt}/compute_ackland_atom.txt (100%) rename doc/{src => txt}/compute_adf.txt (100%) rename doc/{src => txt}/compute_angle.txt (100%) rename doc/{src => txt}/compute_angle_local.txt (100%) rename doc/{src => txt}/compute_angmom_chunk.txt (100%) rename doc/{src => txt}/compute_basal_atom.txt (100%) rename doc/{src => txt}/compute_body_local.txt (100%) rename doc/{src => txt}/compute_bond.txt (100%) rename doc/{src => txt}/compute_bond_local.txt (100%) rename doc/{src => txt}/compute_centro_atom.txt (100%) rename doc/{src => txt}/compute_chunk_atom.txt (100%) rename doc/{src => txt}/compute_chunk_spread_atom.txt (100%) rename doc/{src => txt}/compute_cluster_atom.txt (100%) rename doc/{src => txt}/compute_cna_atom.txt (100%) rename doc/{src => txt}/compute_cnp_atom.txt (100%) rename doc/{src => txt}/compute_com.txt (100%) rename doc/{src => txt}/compute_com_chunk.txt (100%) rename doc/{src => txt}/compute_contact_atom.txt (100%) rename doc/{src => txt}/compute_coord_atom.txt (100%) rename doc/{src => txt}/compute_damage_atom.txt (100%) rename doc/{src => txt}/compute_dihedral.txt (100%) rename doc/{src => txt}/compute_dihedral_local.txt (100%) rename doc/{src => txt}/compute_dilatation_atom.txt (100%) rename doc/{src => txt}/compute_dipole_chunk.txt (100%) rename doc/{src => txt}/compute_displace_atom.txt (100%) rename doc/{src => txt}/compute_dpd.txt (100%) rename doc/{src => txt}/compute_dpd_atom.txt (100%) rename doc/{src => txt}/compute_edpd_temp_atom.txt (100%) rename doc/{src => txt}/compute_entropy_atom.txt (100%) rename doc/{src => txt}/compute_erotate_asphere.txt (100%) rename doc/{src => txt}/compute_erotate_rigid.txt (100%) rename doc/{src => txt}/compute_erotate_sphere.txt (100%) rename doc/{src => txt}/compute_erotate_sphere_atom.txt (100%) rename doc/{src => txt}/compute_event_displace.txt (100%) rename doc/{src => txt}/compute_fep.txt (100%) rename doc/{src => txt}/compute_global_atom.txt (100%) rename doc/{src => txt}/compute_group_group.txt (100%) rename doc/{src => txt}/compute_gyration.txt (100%) rename doc/{src => txt}/compute_gyration_chunk.txt (100%) rename doc/{src => txt}/compute_gyration_shape.txt (100%) rename doc/{src => txt}/compute_heat_flux.txt (100%) rename doc/{src => txt}/compute_hexorder_atom.txt (100%) rename doc/{src => txt}/compute_hma.txt (100%) rename doc/{src => txt}/compute_improper.txt (100%) rename doc/{src => txt}/compute_improper_local.txt (100%) rename doc/{src => txt}/compute_inertia_chunk.txt (100%) rename doc/{src => txt}/compute_ke.txt (100%) rename doc/{src => txt}/compute_ke_atom.txt (100%) rename doc/{src => txt}/compute_ke_atom_eff.txt (100%) rename doc/{src => txt}/compute_ke_eff.txt (100%) rename doc/{src => txt}/compute_ke_rigid.txt (100%) rename doc/{src => txt}/compute_meso_e_atom.txt (100%) rename doc/{src => txt}/compute_meso_rho_atom.txt (100%) rename doc/{src => txt}/compute_meso_t_atom.txt (100%) rename doc/{src => txt}/compute_modify.txt (100%) rename doc/{src => txt}/compute_momentum.txt (100%) rename doc/{src => txt}/compute_msd.txt (100%) rename doc/{src => txt}/compute_msd_chunk.txt (100%) rename doc/{src => txt}/compute_msd_nongauss.txt (100%) rename doc/{src => txt}/compute_omega_chunk.txt (100%) rename doc/{src => txt}/compute_orientorder_atom.txt (100%) rename doc/{src => txt}/compute_pair.txt (100%) rename doc/{src => txt}/compute_pair_local.txt (100%) rename doc/{src => txt}/compute_pe.txt (100%) rename doc/{src => txt}/compute_pe_atom.txt (100%) rename doc/{src => txt}/compute_plasticity_atom.txt (100%) rename doc/{src => txt}/compute_pressure.txt (100%) rename doc/{src => txt}/compute_pressure_cylinder.txt (100%) rename doc/{src => txt}/compute_pressure_uef.txt (100%) rename doc/{src => txt}/compute_property_atom.txt (100%) rename doc/{src => txt}/compute_property_chunk.txt (100%) rename doc/{src => txt}/compute_property_local.txt (100%) rename doc/{src => txt}/compute_ptm_atom.txt (100%) rename doc/{src => txt}/compute_rdf.txt (100%) rename doc/{src => txt}/compute_reduce.txt (100%) rename doc/{src => txt}/compute_reduce_chunk.txt (100%) rename doc/{src => txt}/compute_rigid_local.txt (100%) rename doc/{src => txt}/compute_saed.txt (100%) rename doc/{src => txt}/compute_slice.txt (100%) rename doc/{src => txt}/compute_smd_contact_radius.txt (100%) rename doc/{src => txt}/compute_smd_damage.txt (100%) rename doc/{src => txt}/compute_smd_hourglass_error.txt (100%) rename doc/{src => txt}/compute_smd_internal_energy.txt (100%) rename doc/{src => txt}/compute_smd_plastic_strain.txt (100%) rename doc/{src => txt}/compute_smd_plastic_strain_rate.txt (100%) rename doc/{src => txt}/compute_smd_rho.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_defgrad.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_dt.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_num_neighs.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_shape.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_strain.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_strain_rate.txt (100%) rename doc/{src => txt}/compute_smd_tlsph_stress.txt (100%) rename doc/{src => txt}/compute_smd_triangle_vertices.txt (100%) rename doc/{src => txt}/compute_smd_ulsph_num_neighs.txt (100%) rename doc/{src => txt}/compute_smd_ulsph_strain.txt (100%) rename doc/{src => txt}/compute_smd_ulsph_strain_rate.txt (100%) rename doc/{src => txt}/compute_smd_ulsph_stress.txt (100%) rename doc/{src => txt}/compute_smd_vol.txt (100%) rename doc/{src => txt}/compute_sna_atom.txt (100%) rename doc/{src => txt}/compute_spin.txt (100%) rename doc/{src => txt}/compute_stress_atom.txt (100%) rename doc/{src => txt}/compute_stress_mop.txt (100%) rename doc/{src => txt}/compute_tally.txt (100%) rename doc/{src => txt}/compute_tdpd_cc_atom.txt (100%) rename doc/{src => txt}/compute_temp.txt (100%) rename doc/{src => txt}/compute_temp_asphere.txt (100%) rename doc/{src => txt}/compute_temp_body.txt (100%) rename doc/{src => txt}/compute_temp_chunk.txt (100%) rename doc/{src => txt}/compute_temp_com.txt (100%) rename doc/{src => txt}/compute_temp_cs.txt (100%) rename doc/{src => txt}/compute_temp_deform.txt (100%) rename doc/{src => txt}/compute_temp_deform_eff.txt (100%) rename doc/{src => txt}/compute_temp_drude.txt (100%) rename doc/{src => txt}/compute_temp_eff.txt (100%) rename doc/{src => txt}/compute_temp_partial.txt (100%) rename doc/{src => txt}/compute_temp_profile.txt (100%) rename doc/{src => txt}/compute_temp_ramp.txt (100%) rename doc/{src => txt}/compute_temp_region.txt (100%) rename doc/{src => txt}/compute_temp_region_eff.txt (100%) rename doc/{src => txt}/compute_temp_rotate.txt (100%) rename doc/{src => txt}/compute_temp_sphere.txt (100%) rename doc/{src => txt}/compute_temp_uef.txt (100%) rename doc/{src => txt}/compute_ti.txt (100%) rename doc/{src => txt}/compute_torque_chunk.txt (100%) rename doc/{src => txt}/compute_vacf.txt (100%) rename doc/{src => txt}/compute_vcm_chunk.txt (100%) rename doc/{src => txt}/compute_voronoi_atom.txt (100%) rename doc/{src => txt}/compute_xrd.txt (100%) rename doc/{src => txt}/computes.txt (100%) rename doc/{src => txt}/create_atoms.txt (100%) rename doc/{src => txt}/create_bonds.txt (100%) rename doc/{src => txt}/create_box.txt (100%) rename doc/{src => txt}/delete_atoms.txt (100%) rename doc/{src => txt}/delete_bonds.txt (100%) rename doc/{src => txt}/dielectric.txt (100%) rename doc/{src => txt}/dihedral_charmm.txt (100%) rename doc/{src => txt}/dihedral_class2.txt (100%) rename doc/{src => txt}/dihedral_coeff.txt (100%) rename doc/{src => txt}/dihedral_cosine_shift_exp.txt (100%) rename doc/{src => txt}/dihedral_fourier.txt (100%) rename doc/{src => txt}/dihedral_harmonic.txt (100%) rename doc/{src => txt}/dihedral_helix.txt (100%) rename doc/{src => txt}/dihedral_hybrid.txt (100%) rename doc/{src => txt}/dihedral_multi_harmonic.txt (100%) rename doc/{src => txt}/dihedral_nharmonic.txt (100%) rename doc/{src => txt}/dihedral_none.txt (100%) rename doc/{src => txt}/dihedral_opls.txt (100%) rename doc/{src => txt}/dihedral_quadratic.txt (100%) rename doc/{src => txt}/dihedral_spherical.txt (100%) rename doc/{src => txt}/dihedral_style.txt (100%) rename doc/{src => txt}/dihedral_table.txt (100%) rename doc/{src => txt}/dihedral_table_cut.txt (100%) rename doc/{src => txt}/dihedral_zero.txt (100%) rename doc/{src => txt}/dihedrals.txt (100%) rename doc/{src => txt}/dimension.txt (100%) rename doc/{src => txt}/displace_atoms.txt (100%) rename doc/{src => txt}/dump.txt (100%) rename doc/{src => txt}/dump_adios.txt (100%) rename doc/{src => txt}/dump_cfg_uef.txt (100%) rename doc/{src => txt}/dump_h5md.txt (100%) rename doc/{src => txt}/dump_image.txt (100%) rename doc/{src => txt}/dump_modify.txt (100%) rename doc/{src => txt}/dump_molfile.txt (100%) rename doc/{src => txt}/dump_netcdf.txt (100%) rename doc/{src => txt}/dump_vtk.txt (100%) rename doc/{src => txt}/dynamical_matrix.txt (100%) rename doc/{src => txt}/echo.txt (100%) rename doc/{src => txt}/fix.txt (100%) rename doc/{src => txt}/fix_adapt.txt (100%) rename doc/{src => txt}/fix_adapt_fep.txt (100%) rename doc/{src => txt}/fix_addforce.txt (100%) rename doc/{src => txt}/fix_addtorque.txt (100%) rename doc/{src => txt}/fix_append_atoms.txt (100%) rename doc/{src => txt}/fix_atc.txt (100%) rename doc/{src => txt}/fix_atom_swap.txt (100%) rename doc/{src => txt}/fix_ave_atom.txt (100%) rename doc/{src => txt}/fix_ave_chunk.txt (100%) rename doc/{src => txt}/fix_ave_correlate.txt (100%) rename doc/{src => txt}/fix_ave_correlate_long.txt (100%) rename doc/{src => txt}/fix_ave_histo.txt (100%) rename doc/{src => txt}/fix_ave_time.txt (100%) rename doc/{src => txt}/fix_aveforce.txt (100%) rename doc/{src => txt}/fix_balance.txt (100%) rename doc/{src => txt}/fix_bocs.txt (100%) rename doc/{src => txt}/fix_bond_break.txt (100%) rename doc/{src => txt}/fix_bond_create.txt (100%) rename doc/{src => txt}/fix_bond_react.txt (100%) rename doc/{src => txt}/fix_bond_swap.txt (100%) rename doc/{src => txt}/fix_box_relax.txt (100%) rename doc/{src => txt}/fix_client_md.txt (100%) rename doc/{src => txt}/fix_cmap.txt (100%) rename doc/{src => txt}/fix_colvars.txt (100%) rename doc/{src => txt}/fix_controller.txt (100%) rename doc/{src => txt}/fix_deform.txt (100%) rename doc/{src => txt}/fix_deposit.txt (100%) rename doc/{src => txt}/fix_dpd_energy.txt (100%) rename doc/{src => txt}/fix_dpd_source.txt (100%) rename doc/{src => txt}/fix_drag.txt (100%) rename doc/{src => txt}/fix_drude.txt (100%) rename doc/{src => txt}/fix_drude_transform.txt (100%) rename doc/{src => txt}/fix_dt_reset.txt (100%) rename doc/{src => txt}/fix_efield.txt (100%) rename doc/{src => txt}/fix_ehex.txt (100%) rename doc/{src => txt}/fix_electron_stopping.txt (100%) rename doc/{src => txt}/fix_enforce2d.txt (100%) rename doc/{src => txt}/fix_eos_cv.txt (100%) rename doc/{src => txt}/fix_eos_table.txt (100%) rename doc/{src => txt}/fix_eos_table_rx.txt (100%) rename doc/{src => txt}/fix_evaporate.txt (100%) rename doc/{src => txt}/fix_external.txt (100%) rename doc/{src => txt}/fix_ffl.txt (100%) rename doc/{src => txt}/fix_filter_corotate.txt (100%) rename doc/{src => txt}/fix_flow_gauss.txt (100%) rename doc/{src => txt}/fix_freeze.txt (100%) rename doc/{src => txt}/fix_gcmc.txt (100%) rename doc/{src => txt}/fix_gld.txt (100%) rename doc/{src => txt}/fix_gle.txt (100%) rename doc/{src => txt}/fix_gravity.txt (100%) rename doc/{src => txt}/fix_grem.txt (100%) rename doc/{src => txt}/fix_halt.txt (100%) rename doc/{src => txt}/fix_heat.txt (100%) rename doc/{src => txt}/fix_hyper_global.txt (100%) rename doc/{src => txt}/fix_hyper_local.txt (100%) rename doc/{src => txt}/fix_imd.txt (100%) rename doc/{src => txt}/fix_indent.txt (100%) rename doc/{src => txt}/fix_ipi.txt (100%) rename doc/{src => txt}/fix_langevin.txt (100%) rename doc/{src => txt}/fix_langevin_drude.txt (100%) rename doc/{src => txt}/fix_langevin_eff.txt (100%) rename doc/{src => txt}/fix_langevin_spin.txt (100%) rename doc/{src => txt}/fix_latte.txt (100%) rename doc/{src => txt}/fix_lb_fluid.txt (100%) rename doc/{src => txt}/fix_lb_momentum.txt (100%) rename doc/{src => txt}/fix_lb_pc.txt (100%) rename doc/{src => txt}/fix_lb_rigid_pc_sphere.txt (100%) rename doc/{src => txt}/fix_lb_viscous.txt (100%) rename doc/{src => txt}/fix_lineforce.txt (100%) rename doc/{src => txt}/fix_manifoldforce.txt (100%) rename doc/{src => txt}/fix_meso.txt (100%) rename doc/{src => txt}/fix_meso_move.txt (100%) rename doc/{src => txt}/fix_meso_stationary.txt (100%) rename doc/{src => txt}/fix_modify.txt (100%) rename doc/{src => txt}/fix_momentum.txt (100%) rename doc/{src => txt}/fix_move.txt (100%) rename doc/{src => txt}/fix_mscg.txt (100%) rename doc/{src => txt}/fix_msst.txt (100%) rename doc/{src => txt}/fix_mvv_dpd.txt (100%) rename doc/{src => txt}/fix_neb.txt (100%) rename doc/{src => txt}/fix_neb_spin.txt (100%) rename doc/{src => txt}/fix_nh.txt (100%) rename doc/{src => txt}/fix_nh_eff.txt (100%) rename doc/{src => txt}/fix_nh_uef.txt (100%) rename doc/{src => txt}/fix_nph_asphere.txt (100%) rename doc/{src => txt}/fix_nph_body.txt (100%) rename doc/{src => txt}/fix_nph_sphere.txt (100%) rename doc/{src => txt}/fix_nphug.txt (100%) rename doc/{src => txt}/fix_npt_asphere.txt (100%) rename doc/{src => txt}/fix_npt_body.txt (100%) rename doc/{src => txt}/fix_npt_sphere.txt (100%) rename doc/{src => txt}/fix_nve.txt (100%) rename doc/{src => txt}/fix_nve_asphere.txt (100%) rename doc/{src => txt}/fix_nve_asphere_noforce.txt (100%) rename doc/{src => txt}/fix_nve_awpmd.txt (100%) rename doc/{src => txt}/fix_nve_body.txt (100%) rename doc/{src => txt}/fix_nve_dot.txt (100%) rename doc/{src => txt}/fix_nve_dotc_langevin.txt (100%) rename doc/{src => txt}/fix_nve_eff.txt (100%) rename doc/{src => txt}/fix_nve_limit.txt (100%) rename doc/{src => txt}/fix_nve_line.txt (100%) rename doc/{src => txt}/fix_nve_manifold_rattle.txt (100%) rename doc/{src => txt}/fix_nve_noforce.txt (100%) rename doc/{src => txt}/fix_nve_sphere.txt (100%) rename doc/{src => txt}/fix_nve_spin.txt (100%) rename doc/{src => txt}/fix_nve_tri.txt (100%) rename doc/{src => txt}/fix_nvk.txt (100%) rename doc/{src => txt}/fix_nvt_asphere.txt (100%) rename doc/{src => txt}/fix_nvt_body.txt (100%) rename doc/{src => txt}/fix_nvt_manifold_rattle.txt (100%) rename doc/{src => txt}/fix_nvt_sllod.txt (100%) rename doc/{src => txt}/fix_nvt_sllod_eff.txt (100%) rename doc/{src => txt}/fix_nvt_sphere.txt (100%) rename doc/{src => txt}/fix_oneway.txt (100%) rename doc/{src => txt}/fix_orient.txt (100%) rename doc/{src => txt}/fix_phonon.txt (100%) rename doc/{src => txt}/fix_pimd.txt (100%) rename doc/{src => txt}/fix_planeforce.txt (100%) rename doc/{src => txt}/fix_plumed.txt (100%) rename doc/{src => txt}/fix_poems.txt (100%) rename doc/{src => txt}/fix_pour.txt (100%) rename doc/{src => txt}/fix_precession_spin.txt (100%) rename doc/{src => txt}/fix_press_berendsen.txt (100%) rename doc/{src => txt}/fix_print.txt (100%) rename doc/{src => txt}/fix_property_atom.txt (100%) rename doc/{src => txt}/fix_python_invoke.txt (100%) rename doc/{src => txt}/fix_python_move.txt (100%) rename doc/{src => txt}/fix_qbmsst.txt (100%) rename doc/{src => txt}/fix_qeq.txt (100%) rename doc/{src => txt}/fix_qeq_comb.txt (100%) rename doc/{src => txt}/fix_qeq_reax.txt (100%) rename doc/{src => txt}/fix_qmmm.txt (100%) rename doc/{src => txt}/fix_qtb.txt (100%) rename doc/{src => txt}/fix_reaxc_bonds.txt (100%) rename doc/{src => txt}/fix_reaxc_species.txt (100%) rename doc/{src => txt}/fix_recenter.txt (100%) rename doc/{src => txt}/fix_restrain.txt (100%) rename doc/{src => txt}/fix_rhok.txt (100%) rename doc/{src => txt}/fix_rigid.txt (100%) rename doc/{src => txt}/fix_rigid_meso.txt (100%) rename doc/{src => txt}/fix_rx.txt (100%) rename doc/{src => txt}/fix_saed_vtk.txt (100%) rename doc/{src => txt}/fix_setforce.txt (100%) rename doc/{src => txt}/fix_shake.txt (100%) rename doc/{src => txt}/fix_shardlow.txt (100%) rename doc/{src => txt}/fix_smd.txt (100%) rename doc/{src => txt}/fix_smd_adjust_dt.txt (100%) rename doc/{src => txt}/fix_smd_integrate_tlsph.txt (100%) rename doc/{src => txt}/fix_smd_integrate_ulsph.txt (100%) rename doc/{src => txt}/fix_smd_move_triangulated_surface.txt (100%) rename doc/{src => txt}/fix_smd_setvel.txt (100%) rename doc/{src => txt}/fix_smd_wall_surface.txt (100%) rename doc/{src => txt}/fix_spring.txt (100%) rename doc/{src => txt}/fix_spring_chunk.txt (100%) rename doc/{src => txt}/fix_spring_rg.txt (100%) rename doc/{src => txt}/fix_spring_self.txt (100%) rename doc/{src => txt}/fix_srd.txt (100%) rename doc/{src => txt}/fix_store_force.txt (100%) rename doc/{src => txt}/fix_store_state.txt (100%) rename doc/{src => txt}/fix_temp_berendsen.txt (100%) rename doc/{src => txt}/fix_temp_csvr.txt (100%) rename doc/{src => txt}/fix_temp_rescale.txt (100%) rename doc/{src => txt}/fix_temp_rescale_eff.txt (100%) rename doc/{src => txt}/fix_tfmc.txt (100%) rename doc/{src => txt}/fix_thermal_conductivity.txt (100%) rename doc/{src => txt}/fix_ti_spring.txt (100%) rename doc/{src => txt}/fix_tmd.txt (100%) rename doc/{src => txt}/fix_ttm.txt (100%) rename doc/{src => txt}/fix_tune_kspace.txt (100%) rename doc/{src => txt}/fix_vector.txt (100%) rename doc/{src => txt}/fix_viscosity.txt (100%) rename doc/{src => txt}/fix_viscous.txt (100%) rename doc/{src => txt}/fix_wall.txt (100%) rename doc/{src => txt}/fix_wall_body_polygon.txt (100%) rename doc/{src => txt}/fix_wall_body_polyhedron.txt (100%) rename doc/{src => txt}/fix_wall_ees.txt (100%) rename doc/{src => txt}/fix_wall_gran.txt (100%) rename doc/{src => txt}/fix_wall_gran_region.txt (100%) rename doc/{src => txt}/fix_wall_piston.txt (100%) rename doc/{src => txt}/fix_wall_reflect.txt (100%) rename doc/{src => txt}/fix_wall_region.txt (100%) rename doc/{src => txt}/fix_wall_srd.txt (100%) rename doc/{src => txt}/fixes.txt (100%) rename doc/{src => txt}/group.txt (100%) rename doc/{src => txt}/group2ndx.txt (100%) rename doc/{src => txt}/hyper.txt (100%) rename doc/{src => txt}/if.txt (100%) rename doc/{src => txt}/improper_class2.txt (100%) rename doc/{src => txt}/improper_coeff.txt (100%) rename doc/{src => txt}/improper_cossq.txt (100%) rename doc/{src => txt}/improper_cvff.txt (100%) rename doc/{src => txt}/improper_distance.txt (100%) rename doc/{src => txt}/improper_distharm.txt (100%) rename doc/{src => txt}/improper_fourier.txt (100%) rename doc/{src => txt}/improper_harmonic.txt (100%) rename doc/{src => txt}/improper_hybrid.txt (100%) rename doc/{src => txt}/improper_inversion_harmonic.txt (100%) rename doc/{src => txt}/improper_none.txt (100%) rename doc/{src => txt}/improper_ring.txt (100%) rename doc/{src => txt}/improper_sqdistharm.txt (100%) rename doc/{src => txt}/improper_style.txt (100%) rename doc/{src => txt}/improper_umbrella.txt (100%) rename doc/{src => txt}/improper_zero.txt (100%) rename doc/{src => txt}/impropers.txt (100%) rename doc/{src => txt}/include.txt (100%) rename doc/{src => txt}/info.txt (100%) rename doc/{src => txt}/jump.txt (100%) rename doc/{src => txt}/kim_commands.txt (100%) rename doc/{src => txt}/kspace_modify.txt (100%) rename doc/{src => txt}/kspace_style.txt (100%) rename doc/{src => txt}/label.txt (100%) rename doc/{src => txt}/lammps.book (100%) rename doc/{src => txt}/lammps_commands.txt (100%) rename doc/{src => txt}/lammps_commands_angle.txt (100%) rename doc/{src => txt}/lammps_commands_atc.txt (100%) rename doc/{src => txt}/lammps_commands_bond.txt (100%) rename doc/{src => txt}/lammps_commands_compute.txt (100%) rename doc/{src => txt}/lammps_commands_dihedral.txt (100%) rename doc/{src => txt}/lammps_commands_fix.txt (100%) rename doc/{src => txt}/lammps_commands_improper.txt (100%) rename doc/{src => txt}/lammps_commands_kspace.txt (100%) rename doc/{src => txt}/lammps_commands_pair.txt (100%) rename doc/{src => txt}/lattice.txt (100%) rename doc/{src => txt}/log.txt (100%) rename doc/{src => txt}/mass.txt (100%) rename doc/{src => txt}/message.txt (100%) rename doc/{src => txt}/min_modify.txt (100%) rename doc/{src => txt}/min_spin.txt (100%) rename doc/{src => txt}/min_style.txt (100%) rename doc/{src => txt}/minimize.txt (100%) rename doc/{src => txt}/molecule.txt (100%) rename doc/{src => txt}/neb.txt (100%) rename doc/{src => txt}/neb_spin.txt (100%) rename doc/{src => txt}/neigh_modify.txt (100%) rename doc/{src => txt}/neighbor.txt (100%) rename doc/{src => txt}/newton.txt (100%) rename doc/{src => txt}/next.txt (100%) rename doc/{src => txt}/package.txt (100%) rename doc/{src => txt}/pair_adp.txt (100%) rename doc/{src => txt}/pair_agni.txt (100%) rename doc/{src => txt}/pair_airebo.txt (100%) rename doc/{src => txt}/pair_atm.txt (100%) rename doc/{src => txt}/pair_awpmd.txt (100%) rename doc/{src => txt}/pair_beck.txt (100%) rename doc/{src => txt}/pair_body_nparticle.txt (100%) rename doc/{src => txt}/pair_body_rounded_polygon.txt (100%) rename doc/{src => txt}/pair_body_rounded_polyhedron.txt (100%) rename doc/{src => txt}/pair_bop.txt (100%) rename doc/{src => txt}/pair_born.txt (100%) rename doc/{src => txt}/pair_brownian.txt (100%) rename doc/{src => txt}/pair_buck.txt (100%) rename doc/{src => txt}/pair_buck6d_coul_gauss.txt (100%) rename doc/{src => txt}/pair_buck_long.txt (100%) rename doc/{src => txt}/pair_charmm.txt (100%) rename doc/{src => txt}/pair_class2.txt (100%) rename doc/{src => txt}/pair_coeff.txt (100%) rename doc/{src => txt}/pair_colloid.txt (100%) rename doc/{src => txt}/pair_comb.txt (100%) rename doc/{src => txt}/pair_cosine_squared.txt (100%) rename doc/{src => txt}/pair_coul.txt (100%) rename doc/{src => txt}/pair_coul_diel.txt (100%) rename doc/{src => txt}/pair_coul_shield.txt (100%) rename doc/{src => txt}/pair_cs.txt (100%) rename doc/{src => txt}/pair_dipole.txt (100%) rename doc/{src => txt}/pair_dpd.txt (100%) rename doc/{src => txt}/pair_dpd_fdt.txt (100%) rename doc/{src => txt}/pair_drip.txt (100%) rename doc/{src => txt}/pair_dsmc.txt (100%) rename doc/{src => txt}/pair_e3b.txt (100%) rename doc/{src => txt}/pair_eam.txt (100%) rename doc/{src => txt}/pair_edip.txt (100%) rename doc/{src => txt}/pair_eff.txt (100%) rename doc/{src => txt}/pair_eim.txt (100%) rename doc/{src => txt}/pair_exp6_rx.txt (100%) rename doc/{src => txt}/pair_extep.txt (100%) rename doc/{src => txt}/pair_fep_soft.txt (100%) rename doc/{src => txt}/pair_gauss.txt (100%) rename doc/{src => txt}/pair_gayberne.txt (100%) rename doc/{src => txt}/pair_gran.txt (100%) rename doc/{src => txt}/pair_granular.txt (100%) rename doc/{src => txt}/pair_gromacs.txt (100%) rename doc/{src => txt}/pair_gw.txt (100%) rename doc/{src => txt}/pair_hbond_dreiding.txt (100%) rename doc/{src => txt}/pair_hybrid.txt (100%) rename doc/{src => txt}/pair_ilp_graphene_hbn.txt (100%) rename doc/{src => txt}/pair_kim.txt (100%) rename doc/{src => txt}/pair_kolmogorov_crespi_full.txt (100%) rename doc/{src => txt}/pair_kolmogorov_crespi_z.txt (100%) rename doc/{src => txt}/pair_lcbop.txt (100%) rename doc/{src => txt}/pair_lebedeva_z.txt (100%) rename doc/{src => txt}/pair_line_lj.txt (100%) rename doc/{src => txt}/pair_list.txt (100%) rename doc/{src => txt}/pair_lj.txt (100%) rename doc/{src => txt}/pair_lj96.txt (100%) rename doc/{src => txt}/pair_lj_cubic.txt (100%) rename doc/{src => txt}/pair_lj_expand.txt (100%) rename doc/{src => txt}/pair_lj_long.txt (100%) rename doc/{src => txt}/pair_lj_smooth.txt (100%) rename doc/{src => txt}/pair_lj_smooth_linear.txt (100%) rename doc/{src => txt}/pair_lj_switch3_coulgauss.txt (100%) rename doc/{src => txt}/pair_local_density.txt (100%) rename doc/{src => txt}/pair_lubricate.txt (100%) rename doc/{src => txt}/pair_lubricateU.txt (100%) rename doc/{src => txt}/pair_mdf.txt (100%) rename doc/{src => txt}/pair_meam_spline.txt (100%) rename doc/{src => txt}/pair_meam_sw_spline.txt (100%) rename doc/{src => txt}/pair_meamc.txt (100%) rename doc/{src => txt}/pair_meso.txt (100%) rename doc/{src => txt}/pair_mgpt.txt (100%) rename doc/{src => txt}/pair_mie.txt (100%) rename doc/{src => txt}/pair_mm3_switch3_coulgauss.txt (100%) rename doc/{src => txt}/pair_modify.txt (100%) rename doc/{src => txt}/pair_momb.txt (100%) rename doc/{src => txt}/pair_morse.txt (100%) rename doc/{src => txt}/pair_multi_lucy.txt (100%) rename doc/{src => txt}/pair_multi_lucy_rx.txt (100%) rename doc/{src => txt}/pair_nb3b_harmonic.txt (100%) rename doc/{src => txt}/pair_nm.txt (100%) rename doc/{src => txt}/pair_none.txt (100%) rename doc/{src => txt}/pair_oxdna.txt (100%) rename doc/{src => txt}/pair_oxdna2.txt (100%) rename doc/{src => txt}/pair_peri.txt (100%) rename doc/{src => txt}/pair_polymorphic.txt (100%) rename doc/{src => txt}/pair_python.txt (100%) rename doc/{src => txt}/pair_quip.txt (100%) rename doc/{src => txt}/pair_reaxc.txt (100%) rename doc/{src => txt}/pair_resquared.txt (100%) rename doc/{src => txt}/pair_sdk.txt (100%) rename doc/{src => txt}/pair_sdpd_taitwater_isothermal.txt (100%) rename doc/{src => txt}/pair_smd_hertz.txt (100%) rename doc/{src => txt}/pair_smd_tlsph.txt (100%) rename doc/{src => txt}/pair_smd_triangulated_surface.txt (100%) rename doc/{src => txt}/pair_smd_ulsph.txt (100%) rename doc/{src => txt}/pair_smtbq.txt (100%) rename doc/{src => txt}/pair_snap.txt (100%) rename doc/{src => txt}/pair_soft.txt (100%) rename doc/{src => txt}/pair_sph_heatconduction.txt (100%) rename doc/{src => txt}/pair_sph_idealgas.txt (100%) rename doc/{src => txt}/pair_sph_lj.txt (100%) rename doc/{src => txt}/pair_sph_rhosum.txt (100%) rename doc/{src => txt}/pair_sph_taitwater.txt (100%) rename doc/{src => txt}/pair_sph_taitwater_morris.txt (100%) rename doc/{src => txt}/pair_spin_dipole.txt (100%) rename doc/{src => txt}/pair_spin_dmi.txt (100%) rename doc/{src => txt}/pair_spin_exchange.txt (100%) rename doc/{src => txt}/pair_spin_magelec.txt (100%) rename doc/{src => txt}/pair_spin_neel.txt (100%) rename doc/{src => txt}/pair_srp.txt (100%) rename doc/{src => txt}/pair_style.txt (100%) rename doc/{src => txt}/pair_sw.txt (100%) rename doc/{src => txt}/pair_table.txt (100%) rename doc/{src => txt}/pair_table_rx.txt (100%) rename doc/{src => txt}/pair_tersoff.txt (100%) rename doc/{src => txt}/pair_tersoff_mod.txt (100%) rename doc/{src => txt}/pair_tersoff_zbl.txt (100%) rename doc/{src => txt}/pair_thole.txt (100%) rename doc/{src => txt}/pair_tri_lj.txt (100%) rename doc/{src => txt}/pair_ufm.txt (100%) rename doc/{src => txt}/pair_vashishta.txt (100%) rename doc/{src => txt}/pair_write.txt (100%) rename doc/{src => txt}/pair_yukawa.txt (100%) rename doc/{src => txt}/pair_yukawa_colloid.txt (100%) rename doc/{src => txt}/pair_zbl.txt (100%) rename doc/{src => txt}/pair_zero.txt (100%) rename doc/{src => txt}/pairs.txt (100%) rename doc/{src => txt}/partition.txt (100%) rename doc/{src => txt}/prd.txt (100%) rename doc/{src => txt}/print.txt (100%) rename doc/{src => txt}/processors.txt (100%) rename doc/{src => txt}/python.txt (100%) rename doc/{src => txt}/quit.txt (100%) rename doc/{src => txt}/read_data.txt (100%) rename doc/{src => txt}/read_dump.txt (100%) rename doc/{src => txt}/read_restart.txt (100%) rename doc/{src => txt}/region.txt (100%) rename doc/{src => txt}/replicate.txt (100%) rename doc/{src => txt}/rerun.txt (100%) rename doc/{src => txt}/reset_ids.txt (100%) rename doc/{src => txt}/reset_timestep.txt (100%) rename doc/{src => txt}/restart.txt (100%) rename doc/{src => txt}/run.txt (100%) rename doc/{src => txt}/run_style.txt (100%) rename doc/{src => txt}/server.txt (100%) rename doc/{src => txt}/server_mc.txt (100%) rename doc/{src => txt}/server_md.txt (100%) rename doc/{src => txt}/set.txt (100%) rename doc/{src => txt}/shell.txt (100%) rename doc/{src => txt}/special_bonds.txt (100%) rename doc/{src => txt}/suffix.txt (100%) rename doc/{src => txt}/tad.txt (100%) rename doc/{src => txt}/temper.txt (100%) rename doc/{src => txt}/temper_grem.txt (100%) rename doc/{src => txt}/temper_npt.txt (100%) rename doc/{src => txt}/thermo.txt (100%) rename doc/{src => txt}/thermo_modify.txt (100%) rename doc/{src => txt}/thermo_style.txt (100%) rename doc/{src => txt}/third_order.txt (100%) rename doc/{src => txt}/timer.txt (100%) rename doc/{src => txt}/timestep.txt (100%) rename doc/{src => txt}/uncompute.txt (100%) rename doc/{src => txt}/undump.txt (100%) rename doc/{src => txt}/unfix.txt (100%) rename doc/{src => txt}/units.txt (100%) rename doc/{src => txt}/variable.txt (100%) rename doc/{src => txt}/velocity.txt (100%) rename doc/{src => txt}/write_coeff.txt (100%) rename doc/{src => txt}/write_data.txt (100%) rename doc/{src => txt}/write_dump.txt (100%) rename doc/{src => txt}/write_restart.txt (100%) diff --git a/doc/Makefile b/doc/Makefile index fc5e930121..5dcb070f4f 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -1,11 +1,12 @@ # Makefile for LAMMPS documentation SHELL = /bin/bash -BUILDDIR = ${PWD} -RSTDIR = $(BUILDDIR)/rst +BUILDDIR = ${CURDIR} +RSTDIR = $(BUILDDIR)/src +TXTDIR = $(BUILDDIR)/txt VENV = $(BUILDDIR)/docenv TXT2RST = $(VENV)/bin/txt2rst -ANCHORCHECK = $(VENV)/bin/doc_anchor_check +ANCHORCHECK = $(VENV)/bin/rst_anchor_check PYTHON = $(shell which python3) VIRTUALENV = virtualenv @@ -27,8 +28,8 @@ HAS_VIRTUALENV = YES endif SPHINXEXTRA = -j $(shell $(PYTHON) -c 'import multiprocessing;print(multiprocessing.cpu_count())') -SOURCES=$(filter-out $(wildcard src/lammps_commands*.txt) src/lammps_support.txt src/lammps_tutorials.txt,$(wildcard src/*.txt)) -OBJECTS=$(SOURCES:src/%.txt=$(RSTDIR)/%.rst) +SOURCES=$(filter-out $(wildcard $(TXTDIR)/lammps_commands*.txt) $(TXTDIR)/lammps_support.txt $(TXTDIR)/lammps_tutorials.txt,$(wildcard $(TXTDIR)/*.txt)) +OBJECTS=$(SOURCES:$(TXTDIR)/%.txt=$(RSTDIR)/%.rst) .PHONY: help clean-all clean epub mobi rst html pdf venv spelling anchor_check @@ -53,7 +54,7 @@ clean-all: clean rm -rf $(BUILDDIR)/docenv $(BUILDDIR)/doctrees clean: - rm -rf $(RSTDIR)/{Eqs,JPG,*.rst} html epub latex + rm -rf html epub latex rm -rf spelling clean-spelling: @@ -64,12 +65,10 @@ rst: clean $(OBJECTS) $(ANCHORCHECK) html: $(OBJECTS) $(ANCHORCHECK) @(\ . $(VENV)/bin/activate ;\ - cp -r src/JPG $(RSTDIR)/ ;\ - cp -r src/Eqs $(RSTDIR)/ ;\ sphinx-build $(SPHINXEXTRA) -b html -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) html ;\ echo "############################################" ;\ - doc_anchor_check src/*.txt ;\ - env LC_ALL=C grep -n '[^ -~]' src/*.txt ;\ + rst_anchor_check src/*.rst ;\ + env LC_ALL=C grep -n '[^ -~]' $(RSTDIR)/*.rst ;\ echo "############################################" ;\ deactivate ;\ ) @@ -89,7 +88,7 @@ spelling: $(OBJECTS) utils/sphinx-config/false_positives.txt @(\ . $(VENV)/bin/activate ;\ pip install sphinxcontrib-spelling ;\ - cp utils/sphinx-config/false_positives.txt $(RSTDIR)/ ;\ + cp utils/sphinx-config/false_positives.txt $(RSTDIR)/ ;\ sphinx-build -b spelling -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) spelling ;\ deactivate ;\ ) @@ -126,7 +125,7 @@ pdf: $(OBJECTS) $(ANCHORCHECK) . $(VENV)/bin/activate ;\ sphinx-build $(SPHINXEXTRA) -b latex -c utils/sphinx-config -d $(BUILDDIR)/doctrees $(RSTDIR) latex ;\ echo "############################################" ;\ - doc_anchor_check src/*.txt ;\ + rst_anchor_check src/*.rst ;\ echo "############################################" ;\ deactivate ;\ ) @@ -163,7 +162,7 @@ fetch: anchor_check : $(ANCHORCHECK) @(\ . $(VENV)/bin/activate ;\ - doc_anchor_check src/*.txt ;\ + rst_anchor_check src/*.txt ;\ deactivate ;\ ) diff --git a/doc/rst/.gitignore b/doc/src/.gitignore similarity index 100% rename from doc/rst/.gitignore rename to doc/src/.gitignore diff --git a/doc/rst/Build.rst b/doc/src/Build.rst similarity index 100% rename from doc/rst/Build.rst rename to doc/src/Build.rst diff --git a/doc/rst/Build_basics.rst b/doc/src/Build_basics.rst similarity index 100% rename from doc/rst/Build_basics.rst rename to doc/src/Build_basics.rst diff --git a/doc/rst/Build_cmake.rst b/doc/src/Build_cmake.rst similarity index 100% rename from doc/rst/Build_cmake.rst rename to doc/src/Build_cmake.rst diff --git a/doc/rst/Build_development.rst b/doc/src/Build_development.rst similarity index 100% rename from doc/rst/Build_development.rst rename to doc/src/Build_development.rst diff --git a/doc/rst/Build_extras.rst b/doc/src/Build_extras.rst similarity index 100% rename from doc/rst/Build_extras.rst rename to doc/src/Build_extras.rst diff --git a/doc/rst/Build_link.rst b/doc/src/Build_link.rst similarity index 100% rename from doc/rst/Build_link.rst rename to doc/src/Build_link.rst diff --git a/doc/rst/Build_make.rst b/doc/src/Build_make.rst similarity index 100% rename from doc/rst/Build_make.rst rename to doc/src/Build_make.rst diff --git a/doc/rst/Build_package.rst b/doc/src/Build_package.rst similarity index 100% rename from doc/rst/Build_package.rst rename to doc/src/Build_package.rst diff --git a/doc/rst/Build_settings.rst b/doc/src/Build_settings.rst similarity index 100% rename from doc/rst/Build_settings.rst rename to doc/src/Build_settings.rst diff --git a/doc/rst/Build_windows.rst b/doc/src/Build_windows.rst similarity index 100% rename from doc/rst/Build_windows.rst rename to doc/src/Build_windows.rst diff --git a/doc/rst/Commands.rst b/doc/src/Commands.rst similarity index 100% rename from doc/rst/Commands.rst rename to doc/src/Commands.rst diff --git a/doc/rst/Commands_all.rst b/doc/src/Commands_all.rst similarity index 100% rename from doc/rst/Commands_all.rst rename to doc/src/Commands_all.rst diff --git a/doc/rst/Commands_bond.rst b/doc/src/Commands_bond.rst similarity index 100% rename from doc/rst/Commands_bond.rst rename to doc/src/Commands_bond.rst diff --git a/doc/rst/Commands_category.rst b/doc/src/Commands_category.rst similarity index 100% rename from doc/rst/Commands_category.rst rename to doc/src/Commands_category.rst diff --git a/doc/rst/Commands_compute.rst b/doc/src/Commands_compute.rst similarity index 100% rename from doc/rst/Commands_compute.rst rename to doc/src/Commands_compute.rst diff --git a/doc/rst/Commands_fix.rst b/doc/src/Commands_fix.rst similarity index 100% rename from doc/rst/Commands_fix.rst rename to doc/src/Commands_fix.rst diff --git a/doc/rst/Commands_input.rst b/doc/src/Commands_input.rst similarity index 100% rename from doc/rst/Commands_input.rst rename to doc/src/Commands_input.rst diff --git a/doc/rst/Commands_kspace.rst b/doc/src/Commands_kspace.rst similarity index 100% rename from doc/rst/Commands_kspace.rst rename to doc/src/Commands_kspace.rst diff --git a/doc/rst/Commands_pair.rst b/doc/src/Commands_pair.rst similarity index 100% rename from doc/rst/Commands_pair.rst rename to doc/src/Commands_pair.rst diff --git a/doc/rst/Commands_parse.rst b/doc/src/Commands_parse.rst similarity index 100% rename from doc/rst/Commands_parse.rst rename to doc/src/Commands_parse.rst diff --git a/doc/rst/Commands_removed.rst b/doc/src/Commands_removed.rst similarity index 100% rename from doc/rst/Commands_removed.rst rename to doc/src/Commands_removed.rst diff --git a/doc/rst/Commands_structure.rst b/doc/src/Commands_structure.rst similarity index 100% rename from doc/rst/Commands_structure.rst rename to doc/src/Commands_structure.rst diff --git a/doc/rst/Errors.rst b/doc/src/Errors.rst similarity index 100% rename from doc/rst/Errors.rst rename to doc/src/Errors.rst diff --git a/doc/rst/Errors_bugs.rst b/doc/src/Errors_bugs.rst similarity index 100% rename from doc/rst/Errors_bugs.rst rename to doc/src/Errors_bugs.rst diff --git a/doc/rst/Errors_common.rst b/doc/src/Errors_common.rst similarity index 100% rename from doc/rst/Errors_common.rst rename to doc/src/Errors_common.rst diff --git a/doc/rst/Errors_messages.rst b/doc/src/Errors_messages.rst similarity index 100% rename from doc/rst/Errors_messages.rst rename to doc/src/Errors_messages.rst diff --git a/doc/rst/Errors_warnings.rst b/doc/src/Errors_warnings.rst similarity index 100% rename from doc/rst/Errors_warnings.rst rename to doc/src/Errors_warnings.rst diff --git a/doc/rst/Examples.rst b/doc/src/Examples.rst similarity index 100% rename from doc/rst/Examples.rst rename to doc/src/Examples.rst diff --git a/doc/rst/Howto.rst b/doc/src/Howto.rst similarity index 100% rename from doc/rst/Howto.rst rename to doc/src/Howto.rst diff --git a/doc/rst/Howto_2d.rst b/doc/src/Howto_2d.rst similarity index 100% rename from doc/rst/Howto_2d.rst rename to doc/src/Howto_2d.rst diff --git a/doc/rst/Howto_barostat.rst b/doc/src/Howto_barostat.rst similarity index 100% rename from doc/rst/Howto_barostat.rst rename to doc/src/Howto_barostat.rst diff --git a/doc/rst/Howto_bash.rst b/doc/src/Howto_bash.rst similarity index 100% rename from doc/rst/Howto_bash.rst rename to doc/src/Howto_bash.rst diff --git a/doc/rst/Howto_bioFF.rst b/doc/src/Howto_bioFF.rst similarity index 100% rename from doc/rst/Howto_bioFF.rst rename to doc/src/Howto_bioFF.rst diff --git a/doc/rst/Howto_body.rst b/doc/src/Howto_body.rst similarity index 100% rename from doc/rst/Howto_body.rst rename to doc/src/Howto_body.rst diff --git a/doc/rst/Howto_chunk.rst b/doc/src/Howto_chunk.rst similarity index 100% rename from doc/rst/Howto_chunk.rst rename to doc/src/Howto_chunk.rst diff --git a/doc/rst/Howto_client_server.rst b/doc/src/Howto_client_server.rst similarity index 100% rename from doc/rst/Howto_client_server.rst rename to doc/src/Howto_client_server.rst diff --git a/doc/rst/Howto_coreshell.rst b/doc/src/Howto_coreshell.rst similarity index 100% rename from doc/rst/Howto_coreshell.rst rename to doc/src/Howto_coreshell.rst diff --git a/doc/rst/Howto_couple.rst b/doc/src/Howto_couple.rst similarity index 100% rename from doc/rst/Howto_couple.rst rename to doc/src/Howto_couple.rst diff --git a/doc/rst/Howto_diffusion.rst b/doc/src/Howto_diffusion.rst similarity index 100% rename from doc/rst/Howto_diffusion.rst rename to doc/src/Howto_diffusion.rst diff --git a/doc/rst/Howto_dispersion.rst b/doc/src/Howto_dispersion.rst similarity index 100% rename from doc/rst/Howto_dispersion.rst rename to doc/src/Howto_dispersion.rst diff --git a/doc/rst/Howto_drude.rst b/doc/src/Howto_drude.rst similarity index 100% rename from doc/rst/Howto_drude.rst rename to doc/src/Howto_drude.rst diff --git a/doc/rst/Howto_drude2.rst b/doc/src/Howto_drude2.rst similarity index 100% rename from doc/rst/Howto_drude2.rst rename to doc/src/Howto_drude2.rst diff --git a/doc/rst/Howto_elastic.rst b/doc/src/Howto_elastic.rst similarity index 100% rename from doc/rst/Howto_elastic.rst rename to doc/src/Howto_elastic.rst diff --git a/doc/rst/Howto_github.rst b/doc/src/Howto_github.rst similarity index 100% rename from doc/rst/Howto_github.rst rename to doc/src/Howto_github.rst diff --git a/doc/rst/Howto_granular.rst b/doc/src/Howto_granular.rst similarity index 100% rename from doc/rst/Howto_granular.rst rename to doc/src/Howto_granular.rst diff --git a/doc/rst/Howto_kappa.rst b/doc/src/Howto_kappa.rst similarity index 100% rename from doc/rst/Howto_kappa.rst rename to doc/src/Howto_kappa.rst diff --git a/doc/rst/Howto_library.rst b/doc/src/Howto_library.rst similarity index 100% rename from doc/rst/Howto_library.rst rename to doc/src/Howto_library.rst diff --git a/doc/rst/Howto_manifold.rst b/doc/src/Howto_manifold.rst similarity index 100% rename from doc/rst/Howto_manifold.rst rename to doc/src/Howto_manifold.rst diff --git a/doc/rst/Howto_multiple.rst b/doc/src/Howto_multiple.rst similarity index 100% rename from doc/rst/Howto_multiple.rst rename to doc/src/Howto_multiple.rst diff --git a/doc/rst/Howto_nemd.rst b/doc/src/Howto_nemd.rst similarity index 100% rename from doc/rst/Howto_nemd.rst rename to doc/src/Howto_nemd.rst diff --git a/doc/rst/Howto_output.rst b/doc/src/Howto_output.rst similarity index 100% rename from doc/rst/Howto_output.rst rename to doc/src/Howto_output.rst diff --git a/doc/rst/Howto_polarizable.rst b/doc/src/Howto_polarizable.rst similarity index 100% rename from doc/rst/Howto_polarizable.rst rename to doc/src/Howto_polarizable.rst diff --git a/doc/rst/Howto_pylammps.rst b/doc/src/Howto_pylammps.rst similarity index 100% rename from doc/rst/Howto_pylammps.rst rename to doc/src/Howto_pylammps.rst diff --git a/doc/rst/Howto_replica.rst b/doc/src/Howto_replica.rst similarity index 100% rename from doc/rst/Howto_replica.rst rename to doc/src/Howto_replica.rst diff --git a/doc/rst/Howto_restart.rst b/doc/src/Howto_restart.rst similarity index 100% rename from doc/rst/Howto_restart.rst rename to doc/src/Howto_restart.rst diff --git a/doc/rst/Howto_spc.rst b/doc/src/Howto_spc.rst similarity index 100% rename from doc/rst/Howto_spc.rst rename to doc/src/Howto_spc.rst diff --git a/doc/rst/Howto_spherical.rst b/doc/src/Howto_spherical.rst similarity index 100% rename from doc/rst/Howto_spherical.rst rename to doc/src/Howto_spherical.rst diff --git a/doc/rst/Howto_spins.rst b/doc/src/Howto_spins.rst similarity index 100% rename from doc/rst/Howto_spins.rst rename to doc/src/Howto_spins.rst diff --git a/doc/rst/Howto_temperature.rst b/doc/src/Howto_temperature.rst similarity index 100% rename from doc/rst/Howto_temperature.rst rename to doc/src/Howto_temperature.rst diff --git a/doc/rst/Howto_thermostat.rst b/doc/src/Howto_thermostat.rst similarity index 100% rename from doc/rst/Howto_thermostat.rst rename to doc/src/Howto_thermostat.rst diff --git a/doc/rst/Howto_tip3p.rst b/doc/src/Howto_tip3p.rst similarity index 100% rename from doc/rst/Howto_tip3p.rst rename to doc/src/Howto_tip3p.rst diff --git a/doc/rst/Howto_tip4p.rst b/doc/src/Howto_tip4p.rst similarity index 100% rename from doc/rst/Howto_tip4p.rst rename to doc/src/Howto_tip4p.rst diff --git a/doc/rst/Howto_triclinic.rst b/doc/src/Howto_triclinic.rst similarity index 100% rename from doc/rst/Howto_triclinic.rst rename to doc/src/Howto_triclinic.rst diff --git a/doc/rst/Howto_viscosity.rst b/doc/src/Howto_viscosity.rst similarity index 100% rename from doc/rst/Howto_viscosity.rst rename to doc/src/Howto_viscosity.rst diff --git a/doc/rst/Howto_viz.rst b/doc/src/Howto_viz.rst similarity index 100% rename from doc/rst/Howto_viz.rst rename to doc/src/Howto_viz.rst diff --git a/doc/rst/Howto_walls.rst b/doc/src/Howto_walls.rst similarity index 100% rename from doc/rst/Howto_walls.rst rename to doc/src/Howto_walls.rst diff --git a/doc/rst/Install.rst b/doc/src/Install.rst similarity index 100% rename from doc/rst/Install.rst rename to doc/src/Install.rst diff --git a/doc/rst/Install_git.rst b/doc/src/Install_git.rst similarity index 100% rename from doc/rst/Install_git.rst rename to doc/src/Install_git.rst diff --git a/doc/rst/Install_linux.rst b/doc/src/Install_linux.rst similarity index 100% rename from doc/rst/Install_linux.rst rename to doc/src/Install_linux.rst diff --git a/doc/rst/Install_mac.rst b/doc/src/Install_mac.rst similarity index 100% rename from doc/rst/Install_mac.rst rename to doc/src/Install_mac.rst diff --git a/doc/rst/Install_patch.rst b/doc/src/Install_patch.rst similarity index 100% rename from doc/rst/Install_patch.rst rename to doc/src/Install_patch.rst diff --git a/doc/rst/Install_svn.rst b/doc/src/Install_svn.rst similarity index 100% rename from doc/rst/Install_svn.rst rename to doc/src/Install_svn.rst diff --git a/doc/rst/Install_tarball.rst b/doc/src/Install_tarball.rst similarity index 100% rename from doc/rst/Install_tarball.rst rename to doc/src/Install_tarball.rst diff --git a/doc/rst/Install_windows.rst b/doc/src/Install_windows.rst similarity index 100% rename from doc/rst/Install_windows.rst rename to doc/src/Install_windows.rst diff --git a/doc/rst/Intro.rst b/doc/src/Intro.rst similarity index 100% rename from doc/rst/Intro.rst rename to doc/src/Intro.rst diff --git a/doc/rst/Intro_authors.rst b/doc/src/Intro_authors.rst similarity index 100% rename from doc/rst/Intro_authors.rst rename to doc/src/Intro_authors.rst diff --git a/doc/rst/Intro_features.rst b/doc/src/Intro_features.rst similarity index 100% rename from doc/rst/Intro_features.rst rename to doc/src/Intro_features.rst diff --git a/doc/rst/Intro_nonfeatures.rst b/doc/src/Intro_nonfeatures.rst similarity index 100% rename from doc/rst/Intro_nonfeatures.rst rename to doc/src/Intro_nonfeatures.rst diff --git a/doc/rst/Intro_opensource.rst b/doc/src/Intro_opensource.rst similarity index 100% rename from doc/rst/Intro_opensource.rst rename to doc/src/Intro_opensource.rst diff --git a/doc/rst/Intro_overview.rst b/doc/src/Intro_overview.rst similarity index 100% rename from doc/rst/Intro_overview.rst rename to doc/src/Intro_overview.rst diff --git a/doc/rst/Intro_website.rst b/doc/src/Intro_website.rst similarity index 100% rename from doc/rst/Intro_website.rst rename to doc/src/Intro_website.rst diff --git a/doc/rst/Manual.rst b/doc/src/Manual.rst similarity index 100% rename from doc/rst/Manual.rst rename to doc/src/Manual.rst diff --git a/doc/rst/Manual_build.rst b/doc/src/Manual_build.rst similarity index 100% rename from doc/rst/Manual_build.rst rename to doc/src/Manual_build.rst diff --git a/doc/rst/Manual_version.rst b/doc/src/Manual_version.rst similarity index 100% rename from doc/rst/Manual_version.rst rename to doc/src/Manual_version.rst diff --git a/doc/rst/Modify.rst b/doc/src/Modify.rst similarity index 100% rename from doc/rst/Modify.rst rename to doc/src/Modify.rst diff --git a/doc/rst/Modify_atom.rst b/doc/src/Modify_atom.rst similarity index 100% rename from doc/rst/Modify_atom.rst rename to doc/src/Modify_atom.rst diff --git a/doc/rst/Modify_body.rst b/doc/src/Modify_body.rst similarity index 100% rename from doc/rst/Modify_body.rst rename to doc/src/Modify_body.rst diff --git a/doc/rst/Modify_bond.rst b/doc/src/Modify_bond.rst similarity index 100% rename from doc/rst/Modify_bond.rst rename to doc/src/Modify_bond.rst diff --git a/doc/rst/Modify_command.rst b/doc/src/Modify_command.rst similarity index 100% rename from doc/rst/Modify_command.rst rename to doc/src/Modify_command.rst diff --git a/doc/rst/Modify_compute.rst b/doc/src/Modify_compute.rst similarity index 100% rename from doc/rst/Modify_compute.rst rename to doc/src/Modify_compute.rst diff --git a/doc/rst/Modify_contribute.rst b/doc/src/Modify_contribute.rst similarity index 100% rename from doc/rst/Modify_contribute.rst rename to doc/src/Modify_contribute.rst diff --git a/doc/rst/Modify_dump.rst b/doc/src/Modify_dump.rst similarity index 100% rename from doc/rst/Modify_dump.rst rename to doc/src/Modify_dump.rst diff --git a/doc/rst/Modify_fix.rst b/doc/src/Modify_fix.rst similarity index 100% rename from doc/rst/Modify_fix.rst rename to doc/src/Modify_fix.rst diff --git a/doc/rst/Modify_kspace.rst b/doc/src/Modify_kspace.rst similarity index 100% rename from doc/rst/Modify_kspace.rst rename to doc/src/Modify_kspace.rst diff --git a/doc/rst/Modify_min.rst b/doc/src/Modify_min.rst similarity index 100% rename from doc/rst/Modify_min.rst rename to doc/src/Modify_min.rst diff --git a/doc/rst/Modify_overview.rst b/doc/src/Modify_overview.rst similarity index 100% rename from doc/rst/Modify_overview.rst rename to doc/src/Modify_overview.rst diff --git a/doc/rst/Modify_pair.rst b/doc/src/Modify_pair.rst similarity index 100% rename from doc/rst/Modify_pair.rst rename to doc/src/Modify_pair.rst diff --git a/doc/rst/Modify_region.rst b/doc/src/Modify_region.rst similarity index 100% rename from doc/rst/Modify_region.rst rename to doc/src/Modify_region.rst diff --git a/doc/rst/Modify_thermo.rst b/doc/src/Modify_thermo.rst similarity index 100% rename from doc/rst/Modify_thermo.rst rename to doc/src/Modify_thermo.rst diff --git a/doc/rst/Modify_variable.rst b/doc/src/Modify_variable.rst similarity index 100% rename from doc/rst/Modify_variable.rst rename to doc/src/Modify_variable.rst diff --git a/doc/rst/Packages.rst b/doc/src/Packages.rst similarity index 100% rename from doc/rst/Packages.rst rename to doc/src/Packages.rst diff --git a/doc/rst/Packages_details.rst b/doc/src/Packages_details.rst similarity index 100% rename from doc/rst/Packages_details.rst rename to doc/src/Packages_details.rst diff --git a/doc/rst/Packages_standard.rst b/doc/src/Packages_standard.rst similarity index 100% rename from doc/rst/Packages_standard.rst rename to doc/src/Packages_standard.rst diff --git a/doc/rst/Packages_user.rst b/doc/src/Packages_user.rst similarity index 100% rename from doc/rst/Packages_user.rst rename to doc/src/Packages_user.rst diff --git a/doc/rst/Python_call.rst b/doc/src/Python_call.rst similarity index 100% rename from doc/rst/Python_call.rst rename to doc/src/Python_call.rst diff --git a/doc/rst/Python_examples.rst b/doc/src/Python_examples.rst similarity index 100% rename from doc/rst/Python_examples.rst rename to doc/src/Python_examples.rst diff --git a/doc/rst/Python_head.rst b/doc/src/Python_head.rst similarity index 100% rename from doc/rst/Python_head.rst rename to doc/src/Python_head.rst diff --git a/doc/rst/Python_install.rst b/doc/src/Python_install.rst similarity index 100% rename from doc/rst/Python_install.rst rename to doc/src/Python_install.rst diff --git a/doc/rst/Python_library.rst b/doc/src/Python_library.rst similarity index 100% rename from doc/rst/Python_library.rst rename to doc/src/Python_library.rst diff --git a/doc/rst/Python_mpi.rst b/doc/src/Python_mpi.rst similarity index 100% rename from doc/rst/Python_mpi.rst rename to doc/src/Python_mpi.rst diff --git a/doc/rst/Python_overview.rst b/doc/src/Python_overview.rst similarity index 100% rename from doc/rst/Python_overview.rst rename to doc/src/Python_overview.rst diff --git a/doc/rst/Python_pylammps.rst b/doc/src/Python_pylammps.rst similarity index 100% rename from doc/rst/Python_pylammps.rst rename to doc/src/Python_pylammps.rst diff --git a/doc/rst/Python_run.rst b/doc/src/Python_run.rst similarity index 100% rename from doc/rst/Python_run.rst rename to doc/src/Python_run.rst diff --git a/doc/rst/Python_shlib.rst b/doc/src/Python_shlib.rst similarity index 100% rename from doc/rst/Python_shlib.rst rename to doc/src/Python_shlib.rst diff --git a/doc/rst/Python_test.rst b/doc/src/Python_test.rst similarity index 100% rename from doc/rst/Python_test.rst rename to doc/src/Python_test.rst diff --git a/doc/rst/Run_basics.rst b/doc/src/Run_basics.rst similarity index 100% rename from doc/rst/Run_basics.rst rename to doc/src/Run_basics.rst diff --git a/doc/rst/Run_head.rst b/doc/src/Run_head.rst similarity index 100% rename from doc/rst/Run_head.rst rename to doc/src/Run_head.rst diff --git a/doc/rst/Run_options.rst b/doc/src/Run_options.rst similarity index 100% rename from doc/rst/Run_options.rst rename to doc/src/Run_options.rst diff --git a/doc/rst/Run_output.rst b/doc/src/Run_output.rst similarity index 100% rename from doc/rst/Run_output.rst rename to doc/src/Run_output.rst diff --git a/doc/rst/Run_windows.rst b/doc/src/Run_windows.rst similarity index 100% rename from doc/rst/Run_windows.rst rename to doc/src/Run_windows.rst diff --git a/doc/rst/Speed.rst b/doc/src/Speed.rst similarity index 100% rename from doc/rst/Speed.rst rename to doc/src/Speed.rst diff --git a/doc/rst/Speed_bench.rst b/doc/src/Speed_bench.rst similarity index 100% rename from doc/rst/Speed_bench.rst rename to doc/src/Speed_bench.rst diff --git a/doc/rst/Speed_compare.rst b/doc/src/Speed_compare.rst similarity index 100% rename from doc/rst/Speed_compare.rst rename to doc/src/Speed_compare.rst diff --git a/doc/rst/Speed_gpu.rst b/doc/src/Speed_gpu.rst similarity index 100% rename from doc/rst/Speed_gpu.rst rename to doc/src/Speed_gpu.rst diff --git a/doc/rst/Speed_intel.rst b/doc/src/Speed_intel.rst similarity index 100% rename from doc/rst/Speed_intel.rst rename to doc/src/Speed_intel.rst diff --git a/doc/rst/Speed_kokkos.rst b/doc/src/Speed_kokkos.rst similarity index 100% rename from doc/rst/Speed_kokkos.rst rename to doc/src/Speed_kokkos.rst diff --git a/doc/rst/Speed_measure.rst b/doc/src/Speed_measure.rst similarity index 100% rename from doc/rst/Speed_measure.rst rename to doc/src/Speed_measure.rst diff --git a/doc/rst/Speed_omp.rst b/doc/src/Speed_omp.rst similarity index 100% rename from doc/rst/Speed_omp.rst rename to doc/src/Speed_omp.rst diff --git a/doc/rst/Speed_opt.rst b/doc/src/Speed_opt.rst similarity index 100% rename from doc/rst/Speed_opt.rst rename to doc/src/Speed_opt.rst diff --git a/doc/rst/Speed_packages.rst b/doc/src/Speed_packages.rst similarity index 100% rename from doc/rst/Speed_packages.rst rename to doc/src/Speed_packages.rst diff --git a/doc/rst/Speed_tips.rst b/doc/src/Speed_tips.rst similarity index 100% rename from doc/rst/Speed_tips.rst rename to doc/src/Speed_tips.rst diff --git a/doc/rst/Tools.rst b/doc/src/Tools.rst similarity index 100% rename from doc/rst/Tools.rst rename to doc/src/Tools.rst diff --git a/doc/rst/angle_charmm.rst b/doc/src/angle_charmm.rst similarity index 100% rename from doc/rst/angle_charmm.rst rename to doc/src/angle_charmm.rst diff --git a/doc/rst/angle_class2.rst b/doc/src/angle_class2.rst similarity index 100% rename from doc/rst/angle_class2.rst rename to doc/src/angle_class2.rst diff --git a/doc/rst/angle_coeff.rst b/doc/src/angle_coeff.rst similarity index 100% rename from doc/rst/angle_coeff.rst rename to doc/src/angle_coeff.rst diff --git a/doc/rst/angle_cosine.rst b/doc/src/angle_cosine.rst similarity index 100% rename from doc/rst/angle_cosine.rst rename to doc/src/angle_cosine.rst diff --git a/doc/rst/angle_cosine_buck6d.rst b/doc/src/angle_cosine_buck6d.rst similarity index 100% rename from doc/rst/angle_cosine_buck6d.rst rename to doc/src/angle_cosine_buck6d.rst diff --git a/doc/rst/angle_cosine_delta.rst b/doc/src/angle_cosine_delta.rst similarity index 100% rename from doc/rst/angle_cosine_delta.rst rename to doc/src/angle_cosine_delta.rst diff --git a/doc/rst/angle_cosine_periodic.rst b/doc/src/angle_cosine_periodic.rst similarity index 100% rename from doc/rst/angle_cosine_periodic.rst rename to doc/src/angle_cosine_periodic.rst diff --git a/doc/rst/angle_cosine_shift.rst b/doc/src/angle_cosine_shift.rst similarity index 100% rename from doc/rst/angle_cosine_shift.rst rename to doc/src/angle_cosine_shift.rst diff --git a/doc/rst/angle_cosine_shift_exp.rst b/doc/src/angle_cosine_shift_exp.rst similarity index 100% rename from doc/rst/angle_cosine_shift_exp.rst rename to doc/src/angle_cosine_shift_exp.rst diff --git a/doc/rst/angle_cosine_squared.rst b/doc/src/angle_cosine_squared.rst similarity index 100% rename from doc/rst/angle_cosine_squared.rst rename to doc/src/angle_cosine_squared.rst diff --git a/doc/rst/angle_cross.rst b/doc/src/angle_cross.rst similarity index 100% rename from doc/rst/angle_cross.rst rename to doc/src/angle_cross.rst diff --git a/doc/rst/angle_dipole.rst b/doc/src/angle_dipole.rst similarity index 100% rename from doc/rst/angle_dipole.rst rename to doc/src/angle_dipole.rst diff --git a/doc/rst/angle_fourier.rst b/doc/src/angle_fourier.rst similarity index 100% rename from doc/rst/angle_fourier.rst rename to doc/src/angle_fourier.rst diff --git a/doc/rst/angle_fourier_simple.rst b/doc/src/angle_fourier_simple.rst similarity index 100% rename from doc/rst/angle_fourier_simple.rst rename to doc/src/angle_fourier_simple.rst diff --git a/doc/rst/angle_harmonic.rst b/doc/src/angle_harmonic.rst similarity index 100% rename from doc/rst/angle_harmonic.rst rename to doc/src/angle_harmonic.rst diff --git a/doc/rst/angle_hybrid.rst b/doc/src/angle_hybrid.rst similarity index 100% rename from doc/rst/angle_hybrid.rst rename to doc/src/angle_hybrid.rst diff --git a/doc/rst/angle_mm3.rst b/doc/src/angle_mm3.rst similarity index 100% rename from doc/rst/angle_mm3.rst rename to doc/src/angle_mm3.rst diff --git a/doc/rst/angle_none.rst b/doc/src/angle_none.rst similarity index 100% rename from doc/rst/angle_none.rst rename to doc/src/angle_none.rst diff --git a/doc/rst/angle_quartic.rst b/doc/src/angle_quartic.rst similarity index 100% rename from doc/rst/angle_quartic.rst rename to doc/src/angle_quartic.rst diff --git a/doc/rst/angle_sdk.rst b/doc/src/angle_sdk.rst similarity index 100% rename from doc/rst/angle_sdk.rst rename to doc/src/angle_sdk.rst diff --git a/doc/rst/angle_style.rst b/doc/src/angle_style.rst similarity index 100% rename from doc/rst/angle_style.rst rename to doc/src/angle_style.rst diff --git a/doc/rst/angle_table.rst b/doc/src/angle_table.rst similarity index 100% rename from doc/rst/angle_table.rst rename to doc/src/angle_table.rst diff --git a/doc/rst/angle_zero.rst b/doc/src/angle_zero.rst similarity index 100% rename from doc/rst/angle_zero.rst rename to doc/src/angle_zero.rst diff --git a/doc/rst/angles.rst b/doc/src/angles.rst similarity index 100% rename from doc/rst/angles.rst rename to doc/src/angles.rst diff --git a/doc/rst/atom_modify.rst b/doc/src/atom_modify.rst similarity index 100% rename from doc/rst/atom_modify.rst rename to doc/src/atom_modify.rst diff --git a/doc/rst/atom_style.rst b/doc/src/atom_style.rst similarity index 100% rename from doc/rst/atom_style.rst rename to doc/src/atom_style.rst diff --git a/doc/rst/balance.rst b/doc/src/balance.rst similarity index 100% rename from doc/rst/balance.rst rename to doc/src/balance.rst diff --git a/doc/rst/bond_class2.rst b/doc/src/bond_class2.rst similarity index 100% rename from doc/rst/bond_class2.rst rename to doc/src/bond_class2.rst diff --git a/doc/rst/bond_coeff.rst b/doc/src/bond_coeff.rst similarity index 100% rename from doc/rst/bond_coeff.rst rename to doc/src/bond_coeff.rst diff --git a/doc/rst/bond_fene.rst b/doc/src/bond_fene.rst similarity index 100% rename from doc/rst/bond_fene.rst rename to doc/src/bond_fene.rst diff --git a/doc/rst/bond_fene_expand.rst b/doc/src/bond_fene_expand.rst similarity index 100% rename from doc/rst/bond_fene_expand.rst rename to doc/src/bond_fene_expand.rst diff --git a/doc/rst/bond_gromos.rst b/doc/src/bond_gromos.rst similarity index 100% rename from doc/rst/bond_gromos.rst rename to doc/src/bond_gromos.rst diff --git a/doc/rst/bond_harmonic.rst b/doc/src/bond_harmonic.rst similarity index 100% rename from doc/rst/bond_harmonic.rst rename to doc/src/bond_harmonic.rst diff --git a/doc/rst/bond_harmonic_shift.rst b/doc/src/bond_harmonic_shift.rst similarity index 100% rename from doc/rst/bond_harmonic_shift.rst rename to doc/src/bond_harmonic_shift.rst diff --git a/doc/rst/bond_harmonic_shift_cut.rst b/doc/src/bond_harmonic_shift_cut.rst similarity index 100% rename from doc/rst/bond_harmonic_shift_cut.rst rename to doc/src/bond_harmonic_shift_cut.rst diff --git a/doc/rst/bond_hybrid.rst b/doc/src/bond_hybrid.rst similarity index 100% rename from doc/rst/bond_hybrid.rst rename to doc/src/bond_hybrid.rst diff --git a/doc/rst/bond_mm3.rst b/doc/src/bond_mm3.rst similarity index 100% rename from doc/rst/bond_mm3.rst rename to doc/src/bond_mm3.rst diff --git a/doc/rst/bond_morse.rst b/doc/src/bond_morse.rst similarity index 100% rename from doc/rst/bond_morse.rst rename to doc/src/bond_morse.rst diff --git a/doc/rst/bond_none.rst b/doc/src/bond_none.rst similarity index 100% rename from doc/rst/bond_none.rst rename to doc/src/bond_none.rst diff --git a/doc/rst/bond_nonlinear.rst b/doc/src/bond_nonlinear.rst similarity index 100% rename from doc/rst/bond_nonlinear.rst rename to doc/src/bond_nonlinear.rst diff --git a/doc/rst/bond_oxdna.rst b/doc/src/bond_oxdna.rst similarity index 100% rename from doc/rst/bond_oxdna.rst rename to doc/src/bond_oxdna.rst diff --git a/doc/rst/bond_quartic.rst b/doc/src/bond_quartic.rst similarity index 100% rename from doc/rst/bond_quartic.rst rename to doc/src/bond_quartic.rst diff --git a/doc/rst/bond_style.rst b/doc/src/bond_style.rst similarity index 100% rename from doc/rst/bond_style.rst rename to doc/src/bond_style.rst diff --git a/doc/rst/bond_table.rst b/doc/src/bond_table.rst similarity index 100% rename from doc/rst/bond_table.rst rename to doc/src/bond_table.rst diff --git a/doc/rst/bond_write.rst b/doc/src/bond_write.rst similarity index 100% rename from doc/rst/bond_write.rst rename to doc/src/bond_write.rst diff --git a/doc/rst/bond_zero.rst b/doc/src/bond_zero.rst similarity index 100% rename from doc/rst/bond_zero.rst rename to doc/src/bond_zero.rst diff --git a/doc/rst/bonds.rst b/doc/src/bonds.rst similarity index 100% rename from doc/rst/bonds.rst rename to doc/src/bonds.rst diff --git a/doc/rst/boundary.rst b/doc/src/boundary.rst similarity index 100% rename from doc/rst/boundary.rst rename to doc/src/boundary.rst diff --git a/doc/rst/box.rst b/doc/src/box.rst similarity index 100% rename from doc/rst/box.rst rename to doc/src/box.rst diff --git a/doc/rst/change_box.rst b/doc/src/change_box.rst similarity index 100% rename from doc/rst/change_box.rst rename to doc/src/change_box.rst diff --git a/doc/rst/clear.rst b/doc/src/clear.rst similarity index 100% rename from doc/rst/clear.rst rename to doc/src/clear.rst diff --git a/doc/rst/comm_modify.rst b/doc/src/comm_modify.rst similarity index 100% rename from doc/rst/comm_modify.rst rename to doc/src/comm_modify.rst diff --git a/doc/rst/comm_style.rst b/doc/src/comm_style.rst similarity index 100% rename from doc/rst/comm_style.rst rename to doc/src/comm_style.rst diff --git a/doc/rst/commands_list.rst b/doc/src/commands_list.rst similarity index 100% rename from doc/rst/commands_list.rst rename to doc/src/commands_list.rst diff --git a/doc/rst/compute.rst b/doc/src/compute.rst similarity index 100% rename from doc/rst/compute.rst rename to doc/src/compute.rst diff --git a/doc/rst/compute_ackland_atom.rst b/doc/src/compute_ackland_atom.rst similarity index 100% rename from doc/rst/compute_ackland_atom.rst rename to doc/src/compute_ackland_atom.rst diff --git a/doc/rst/compute_adf.rst b/doc/src/compute_adf.rst similarity index 100% rename from doc/rst/compute_adf.rst rename to doc/src/compute_adf.rst diff --git a/doc/rst/compute_angle.rst b/doc/src/compute_angle.rst similarity index 100% rename from doc/rst/compute_angle.rst rename to doc/src/compute_angle.rst diff --git a/doc/rst/compute_angle_local.rst b/doc/src/compute_angle_local.rst similarity index 100% rename from doc/rst/compute_angle_local.rst rename to doc/src/compute_angle_local.rst diff --git a/doc/rst/compute_angmom_chunk.rst b/doc/src/compute_angmom_chunk.rst similarity index 100% rename from doc/rst/compute_angmom_chunk.rst rename to doc/src/compute_angmom_chunk.rst diff --git a/doc/rst/compute_basal_atom.rst b/doc/src/compute_basal_atom.rst similarity index 100% rename from doc/rst/compute_basal_atom.rst rename to doc/src/compute_basal_atom.rst diff --git a/doc/rst/compute_body_local.rst b/doc/src/compute_body_local.rst similarity index 100% rename from doc/rst/compute_body_local.rst rename to doc/src/compute_body_local.rst diff --git a/doc/rst/compute_bond.rst b/doc/src/compute_bond.rst similarity index 100% rename from doc/rst/compute_bond.rst rename to doc/src/compute_bond.rst diff --git a/doc/rst/compute_bond_local.rst b/doc/src/compute_bond_local.rst similarity index 100% rename from doc/rst/compute_bond_local.rst rename to doc/src/compute_bond_local.rst diff --git a/doc/rst/compute_centro_atom.rst b/doc/src/compute_centro_atom.rst similarity index 100% rename from doc/rst/compute_centro_atom.rst rename to doc/src/compute_centro_atom.rst diff --git a/doc/rst/compute_chunk_atom.rst b/doc/src/compute_chunk_atom.rst similarity index 100% rename from doc/rst/compute_chunk_atom.rst rename to doc/src/compute_chunk_atom.rst diff --git a/doc/rst/compute_chunk_spread_atom.rst b/doc/src/compute_chunk_spread_atom.rst similarity index 100% rename from doc/rst/compute_chunk_spread_atom.rst rename to doc/src/compute_chunk_spread_atom.rst diff --git a/doc/rst/compute_cluster_atom.rst b/doc/src/compute_cluster_atom.rst similarity index 100% rename from doc/rst/compute_cluster_atom.rst rename to doc/src/compute_cluster_atom.rst diff --git a/doc/rst/compute_cna_atom.rst b/doc/src/compute_cna_atom.rst similarity index 100% rename from doc/rst/compute_cna_atom.rst rename to doc/src/compute_cna_atom.rst diff --git a/doc/rst/compute_cnp_atom.rst b/doc/src/compute_cnp_atom.rst similarity index 100% rename from doc/rst/compute_cnp_atom.rst rename to doc/src/compute_cnp_atom.rst diff --git a/doc/rst/compute_com.rst b/doc/src/compute_com.rst similarity index 100% rename from doc/rst/compute_com.rst rename to doc/src/compute_com.rst diff --git a/doc/rst/compute_com_chunk.rst b/doc/src/compute_com_chunk.rst similarity index 100% rename from doc/rst/compute_com_chunk.rst rename to doc/src/compute_com_chunk.rst diff --git a/doc/rst/compute_contact_atom.rst b/doc/src/compute_contact_atom.rst similarity index 100% rename from doc/rst/compute_contact_atom.rst rename to doc/src/compute_contact_atom.rst diff --git a/doc/rst/compute_coord_atom.rst b/doc/src/compute_coord_atom.rst similarity index 100% rename from doc/rst/compute_coord_atom.rst rename to doc/src/compute_coord_atom.rst diff --git a/doc/rst/compute_damage_atom.rst b/doc/src/compute_damage_atom.rst similarity index 100% rename from doc/rst/compute_damage_atom.rst rename to doc/src/compute_damage_atom.rst diff --git a/doc/rst/compute_dihedral.rst b/doc/src/compute_dihedral.rst similarity index 100% rename from doc/rst/compute_dihedral.rst rename to doc/src/compute_dihedral.rst diff --git a/doc/rst/compute_dihedral_local.rst b/doc/src/compute_dihedral_local.rst similarity index 100% rename from doc/rst/compute_dihedral_local.rst rename to doc/src/compute_dihedral_local.rst diff --git a/doc/rst/compute_dilatation_atom.rst b/doc/src/compute_dilatation_atom.rst similarity index 100% rename from doc/rst/compute_dilatation_atom.rst rename to doc/src/compute_dilatation_atom.rst diff --git a/doc/rst/compute_dipole_chunk.rst b/doc/src/compute_dipole_chunk.rst similarity index 100% rename from doc/rst/compute_dipole_chunk.rst rename to doc/src/compute_dipole_chunk.rst diff --git a/doc/rst/compute_displace_atom.rst b/doc/src/compute_displace_atom.rst similarity index 100% rename from doc/rst/compute_displace_atom.rst rename to doc/src/compute_displace_atom.rst diff --git a/doc/rst/compute_dpd.rst b/doc/src/compute_dpd.rst similarity index 100% rename from doc/rst/compute_dpd.rst rename to doc/src/compute_dpd.rst diff --git a/doc/rst/compute_dpd_atom.rst b/doc/src/compute_dpd_atom.rst similarity index 100% rename from doc/rst/compute_dpd_atom.rst rename to doc/src/compute_dpd_atom.rst diff --git a/doc/rst/compute_edpd_temp_atom.rst b/doc/src/compute_edpd_temp_atom.rst similarity index 100% rename from doc/rst/compute_edpd_temp_atom.rst rename to doc/src/compute_edpd_temp_atom.rst diff --git a/doc/rst/compute_entropy_atom.rst b/doc/src/compute_entropy_atom.rst similarity index 100% rename from doc/rst/compute_entropy_atom.rst rename to doc/src/compute_entropy_atom.rst diff --git a/doc/rst/compute_erotate_asphere.rst b/doc/src/compute_erotate_asphere.rst similarity index 100% rename from doc/rst/compute_erotate_asphere.rst rename to doc/src/compute_erotate_asphere.rst diff --git a/doc/rst/compute_erotate_rigid.rst b/doc/src/compute_erotate_rigid.rst similarity index 100% rename from doc/rst/compute_erotate_rigid.rst rename to doc/src/compute_erotate_rigid.rst diff --git a/doc/rst/compute_erotate_sphere.rst b/doc/src/compute_erotate_sphere.rst similarity index 100% rename from doc/rst/compute_erotate_sphere.rst rename to doc/src/compute_erotate_sphere.rst diff --git a/doc/rst/compute_erotate_sphere_atom.rst b/doc/src/compute_erotate_sphere_atom.rst similarity index 100% rename from doc/rst/compute_erotate_sphere_atom.rst rename to doc/src/compute_erotate_sphere_atom.rst diff --git a/doc/rst/compute_event_displace.rst b/doc/src/compute_event_displace.rst similarity index 100% rename from doc/rst/compute_event_displace.rst rename to doc/src/compute_event_displace.rst diff --git a/doc/rst/compute_fep.rst b/doc/src/compute_fep.rst similarity index 100% rename from doc/rst/compute_fep.rst rename to doc/src/compute_fep.rst diff --git a/doc/rst/compute_global_atom.rst b/doc/src/compute_global_atom.rst similarity index 100% rename from doc/rst/compute_global_atom.rst rename to doc/src/compute_global_atom.rst diff --git a/doc/rst/compute_group_group.rst b/doc/src/compute_group_group.rst similarity index 100% rename from doc/rst/compute_group_group.rst rename to doc/src/compute_group_group.rst diff --git a/doc/rst/compute_gyration.rst b/doc/src/compute_gyration.rst similarity index 100% rename from doc/rst/compute_gyration.rst rename to doc/src/compute_gyration.rst diff --git a/doc/rst/compute_gyration_chunk.rst b/doc/src/compute_gyration_chunk.rst similarity index 100% rename from doc/rst/compute_gyration_chunk.rst rename to doc/src/compute_gyration_chunk.rst diff --git a/doc/rst/compute_gyration_shape.rst b/doc/src/compute_gyration_shape.rst similarity index 100% rename from doc/rst/compute_gyration_shape.rst rename to doc/src/compute_gyration_shape.rst diff --git a/doc/rst/compute_heat_flux.rst b/doc/src/compute_heat_flux.rst similarity index 100% rename from doc/rst/compute_heat_flux.rst rename to doc/src/compute_heat_flux.rst diff --git a/doc/rst/compute_hexorder_atom.rst b/doc/src/compute_hexorder_atom.rst similarity index 100% rename from doc/rst/compute_hexorder_atom.rst rename to doc/src/compute_hexorder_atom.rst diff --git a/doc/rst/compute_hma.rst b/doc/src/compute_hma.rst similarity index 100% rename from doc/rst/compute_hma.rst rename to doc/src/compute_hma.rst diff --git a/doc/rst/compute_improper.rst b/doc/src/compute_improper.rst similarity index 100% rename from doc/rst/compute_improper.rst rename to doc/src/compute_improper.rst diff --git a/doc/rst/compute_improper_local.rst b/doc/src/compute_improper_local.rst similarity index 100% rename from doc/rst/compute_improper_local.rst rename to doc/src/compute_improper_local.rst diff --git a/doc/rst/compute_inertia_chunk.rst b/doc/src/compute_inertia_chunk.rst similarity index 100% rename from doc/rst/compute_inertia_chunk.rst rename to doc/src/compute_inertia_chunk.rst diff --git a/doc/rst/compute_ke.rst b/doc/src/compute_ke.rst similarity index 100% rename from doc/rst/compute_ke.rst rename to doc/src/compute_ke.rst diff --git a/doc/rst/compute_ke_atom.rst b/doc/src/compute_ke_atom.rst similarity index 100% rename from doc/rst/compute_ke_atom.rst rename to doc/src/compute_ke_atom.rst diff --git a/doc/rst/compute_ke_atom_eff.rst b/doc/src/compute_ke_atom_eff.rst similarity index 100% rename from doc/rst/compute_ke_atom_eff.rst rename to doc/src/compute_ke_atom_eff.rst diff --git a/doc/rst/compute_ke_eff.rst b/doc/src/compute_ke_eff.rst similarity index 100% rename from doc/rst/compute_ke_eff.rst rename to doc/src/compute_ke_eff.rst diff --git a/doc/rst/compute_ke_rigid.rst b/doc/src/compute_ke_rigid.rst similarity index 100% rename from doc/rst/compute_ke_rigid.rst rename to doc/src/compute_ke_rigid.rst diff --git a/doc/rst/compute_meso_e_atom.rst b/doc/src/compute_meso_e_atom.rst similarity index 100% rename from doc/rst/compute_meso_e_atom.rst rename to doc/src/compute_meso_e_atom.rst diff --git a/doc/rst/compute_meso_rho_atom.rst b/doc/src/compute_meso_rho_atom.rst similarity index 100% rename from doc/rst/compute_meso_rho_atom.rst rename to doc/src/compute_meso_rho_atom.rst diff --git a/doc/rst/compute_meso_t_atom.rst b/doc/src/compute_meso_t_atom.rst similarity index 100% rename from doc/rst/compute_meso_t_atom.rst rename to doc/src/compute_meso_t_atom.rst diff --git a/doc/rst/compute_modify.rst b/doc/src/compute_modify.rst similarity index 100% rename from doc/rst/compute_modify.rst rename to doc/src/compute_modify.rst diff --git a/doc/rst/compute_momentum.rst b/doc/src/compute_momentum.rst similarity index 100% rename from doc/rst/compute_momentum.rst rename to doc/src/compute_momentum.rst diff --git a/doc/rst/compute_msd.rst b/doc/src/compute_msd.rst similarity index 100% rename from doc/rst/compute_msd.rst rename to doc/src/compute_msd.rst diff --git a/doc/rst/compute_msd_chunk.rst b/doc/src/compute_msd_chunk.rst similarity index 100% rename from doc/rst/compute_msd_chunk.rst rename to doc/src/compute_msd_chunk.rst diff --git a/doc/rst/compute_msd_nongauss.rst b/doc/src/compute_msd_nongauss.rst similarity index 100% rename from doc/rst/compute_msd_nongauss.rst rename to doc/src/compute_msd_nongauss.rst diff --git a/doc/rst/compute_omega_chunk.rst b/doc/src/compute_omega_chunk.rst similarity index 100% rename from doc/rst/compute_omega_chunk.rst rename to doc/src/compute_omega_chunk.rst diff --git a/doc/rst/compute_orientorder_atom.rst b/doc/src/compute_orientorder_atom.rst similarity index 100% rename from doc/rst/compute_orientorder_atom.rst rename to doc/src/compute_orientorder_atom.rst diff --git a/doc/rst/compute_pair.rst b/doc/src/compute_pair.rst similarity index 100% rename from doc/rst/compute_pair.rst rename to doc/src/compute_pair.rst diff --git a/doc/rst/compute_pair_local.rst b/doc/src/compute_pair_local.rst similarity index 100% rename from doc/rst/compute_pair_local.rst rename to doc/src/compute_pair_local.rst diff --git a/doc/rst/compute_pe.rst b/doc/src/compute_pe.rst similarity index 100% rename from doc/rst/compute_pe.rst rename to doc/src/compute_pe.rst diff --git a/doc/rst/compute_pe_atom.rst b/doc/src/compute_pe_atom.rst similarity index 100% rename from doc/rst/compute_pe_atom.rst rename to doc/src/compute_pe_atom.rst diff --git a/doc/rst/compute_plasticity_atom.rst b/doc/src/compute_plasticity_atom.rst similarity index 100% rename from doc/rst/compute_plasticity_atom.rst rename to doc/src/compute_plasticity_atom.rst diff --git a/doc/rst/compute_pressure.rst b/doc/src/compute_pressure.rst similarity index 100% rename from doc/rst/compute_pressure.rst rename to doc/src/compute_pressure.rst diff --git a/doc/rst/compute_pressure_cylinder.rst b/doc/src/compute_pressure_cylinder.rst similarity index 100% rename from doc/rst/compute_pressure_cylinder.rst rename to doc/src/compute_pressure_cylinder.rst diff --git a/doc/rst/compute_pressure_uef.rst b/doc/src/compute_pressure_uef.rst similarity index 100% rename from doc/rst/compute_pressure_uef.rst rename to doc/src/compute_pressure_uef.rst diff --git a/doc/rst/compute_property_atom.rst b/doc/src/compute_property_atom.rst similarity index 100% rename from doc/rst/compute_property_atom.rst rename to doc/src/compute_property_atom.rst diff --git a/doc/rst/compute_property_chunk.rst b/doc/src/compute_property_chunk.rst similarity index 100% rename from doc/rst/compute_property_chunk.rst rename to doc/src/compute_property_chunk.rst diff --git a/doc/rst/compute_property_local.rst b/doc/src/compute_property_local.rst similarity index 100% rename from doc/rst/compute_property_local.rst rename to doc/src/compute_property_local.rst diff --git a/doc/rst/compute_ptm_atom.rst b/doc/src/compute_ptm_atom.rst similarity index 100% rename from doc/rst/compute_ptm_atom.rst rename to doc/src/compute_ptm_atom.rst diff --git a/doc/rst/compute_rdf.rst b/doc/src/compute_rdf.rst similarity index 100% rename from doc/rst/compute_rdf.rst rename to doc/src/compute_rdf.rst diff --git a/doc/rst/compute_reduce.rst b/doc/src/compute_reduce.rst similarity index 100% rename from doc/rst/compute_reduce.rst rename to doc/src/compute_reduce.rst diff --git a/doc/rst/compute_reduce_chunk.rst b/doc/src/compute_reduce_chunk.rst similarity index 100% rename from doc/rst/compute_reduce_chunk.rst rename to doc/src/compute_reduce_chunk.rst diff --git a/doc/rst/compute_rigid_local.rst b/doc/src/compute_rigid_local.rst similarity index 100% rename from doc/rst/compute_rigid_local.rst rename to doc/src/compute_rigid_local.rst diff --git a/doc/rst/compute_saed.rst b/doc/src/compute_saed.rst similarity index 100% rename from doc/rst/compute_saed.rst rename to doc/src/compute_saed.rst diff --git a/doc/rst/compute_slice.rst b/doc/src/compute_slice.rst similarity index 100% rename from doc/rst/compute_slice.rst rename to doc/src/compute_slice.rst diff --git a/doc/rst/compute_smd_contact_radius.rst b/doc/src/compute_smd_contact_radius.rst similarity index 100% rename from doc/rst/compute_smd_contact_radius.rst rename to doc/src/compute_smd_contact_radius.rst diff --git a/doc/rst/compute_smd_damage.rst b/doc/src/compute_smd_damage.rst similarity index 100% rename from doc/rst/compute_smd_damage.rst rename to doc/src/compute_smd_damage.rst diff --git a/doc/rst/compute_smd_hourglass_error.rst b/doc/src/compute_smd_hourglass_error.rst similarity index 100% rename from doc/rst/compute_smd_hourglass_error.rst rename to doc/src/compute_smd_hourglass_error.rst diff --git a/doc/rst/compute_smd_internal_energy.rst b/doc/src/compute_smd_internal_energy.rst similarity index 100% rename from doc/rst/compute_smd_internal_energy.rst rename to doc/src/compute_smd_internal_energy.rst diff --git a/doc/rst/compute_smd_plastic_strain.rst b/doc/src/compute_smd_plastic_strain.rst similarity index 100% rename from doc/rst/compute_smd_plastic_strain.rst rename to doc/src/compute_smd_plastic_strain.rst diff --git a/doc/rst/compute_smd_plastic_strain_rate.rst b/doc/src/compute_smd_plastic_strain_rate.rst similarity index 100% rename from doc/rst/compute_smd_plastic_strain_rate.rst rename to doc/src/compute_smd_plastic_strain_rate.rst diff --git a/doc/rst/compute_smd_rho.rst b/doc/src/compute_smd_rho.rst similarity index 100% rename from doc/rst/compute_smd_rho.rst rename to doc/src/compute_smd_rho.rst diff --git a/doc/rst/compute_smd_tlsph_defgrad.rst b/doc/src/compute_smd_tlsph_defgrad.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_defgrad.rst rename to doc/src/compute_smd_tlsph_defgrad.rst diff --git a/doc/rst/compute_smd_tlsph_dt.rst b/doc/src/compute_smd_tlsph_dt.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_dt.rst rename to doc/src/compute_smd_tlsph_dt.rst diff --git a/doc/rst/compute_smd_tlsph_num_neighs.rst b/doc/src/compute_smd_tlsph_num_neighs.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_num_neighs.rst rename to doc/src/compute_smd_tlsph_num_neighs.rst diff --git a/doc/rst/compute_smd_tlsph_shape.rst b/doc/src/compute_smd_tlsph_shape.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_shape.rst rename to doc/src/compute_smd_tlsph_shape.rst diff --git a/doc/rst/compute_smd_tlsph_strain.rst b/doc/src/compute_smd_tlsph_strain.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_strain.rst rename to doc/src/compute_smd_tlsph_strain.rst diff --git a/doc/rst/compute_smd_tlsph_strain_rate.rst b/doc/src/compute_smd_tlsph_strain_rate.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_strain_rate.rst rename to doc/src/compute_smd_tlsph_strain_rate.rst diff --git a/doc/rst/compute_smd_tlsph_stress.rst b/doc/src/compute_smd_tlsph_stress.rst similarity index 100% rename from doc/rst/compute_smd_tlsph_stress.rst rename to doc/src/compute_smd_tlsph_stress.rst diff --git a/doc/rst/compute_smd_triangle_vertices.rst b/doc/src/compute_smd_triangle_vertices.rst similarity index 100% rename from doc/rst/compute_smd_triangle_vertices.rst rename to doc/src/compute_smd_triangle_vertices.rst diff --git a/doc/rst/compute_smd_ulsph_num_neighs.rst b/doc/src/compute_smd_ulsph_num_neighs.rst similarity index 100% rename from doc/rst/compute_smd_ulsph_num_neighs.rst rename to doc/src/compute_smd_ulsph_num_neighs.rst diff --git a/doc/rst/compute_smd_ulsph_strain.rst b/doc/src/compute_smd_ulsph_strain.rst similarity index 100% rename from doc/rst/compute_smd_ulsph_strain.rst rename to doc/src/compute_smd_ulsph_strain.rst diff --git a/doc/rst/compute_smd_ulsph_strain_rate.rst b/doc/src/compute_smd_ulsph_strain_rate.rst similarity index 100% rename from doc/rst/compute_smd_ulsph_strain_rate.rst rename to doc/src/compute_smd_ulsph_strain_rate.rst diff --git a/doc/rst/compute_smd_ulsph_stress.rst b/doc/src/compute_smd_ulsph_stress.rst similarity index 100% rename from doc/rst/compute_smd_ulsph_stress.rst rename to doc/src/compute_smd_ulsph_stress.rst diff --git a/doc/rst/compute_smd_vol.rst b/doc/src/compute_smd_vol.rst similarity index 100% rename from doc/rst/compute_smd_vol.rst rename to doc/src/compute_smd_vol.rst diff --git a/doc/rst/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst similarity index 100% rename from doc/rst/compute_sna_atom.rst rename to doc/src/compute_sna_atom.rst diff --git a/doc/rst/compute_spin.rst b/doc/src/compute_spin.rst similarity index 100% rename from doc/rst/compute_spin.rst rename to doc/src/compute_spin.rst diff --git a/doc/rst/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst similarity index 100% rename from doc/rst/compute_stress_atom.rst rename to doc/src/compute_stress_atom.rst diff --git a/doc/rst/compute_stress_mop.rst b/doc/src/compute_stress_mop.rst similarity index 100% rename from doc/rst/compute_stress_mop.rst rename to doc/src/compute_stress_mop.rst diff --git a/doc/rst/compute_tally.rst b/doc/src/compute_tally.rst similarity index 100% rename from doc/rst/compute_tally.rst rename to doc/src/compute_tally.rst diff --git a/doc/rst/compute_tdpd_cc_atom.rst b/doc/src/compute_tdpd_cc_atom.rst similarity index 100% rename from doc/rst/compute_tdpd_cc_atom.rst rename to doc/src/compute_tdpd_cc_atom.rst diff --git a/doc/rst/compute_temp.rst b/doc/src/compute_temp.rst similarity index 100% rename from doc/rst/compute_temp.rst rename to doc/src/compute_temp.rst diff --git a/doc/rst/compute_temp_asphere.rst b/doc/src/compute_temp_asphere.rst similarity index 100% rename from doc/rst/compute_temp_asphere.rst rename to doc/src/compute_temp_asphere.rst diff --git a/doc/rst/compute_temp_body.rst b/doc/src/compute_temp_body.rst similarity index 100% rename from doc/rst/compute_temp_body.rst rename to doc/src/compute_temp_body.rst diff --git a/doc/rst/compute_temp_chunk.rst b/doc/src/compute_temp_chunk.rst similarity index 100% rename from doc/rst/compute_temp_chunk.rst rename to doc/src/compute_temp_chunk.rst diff --git a/doc/rst/compute_temp_com.rst b/doc/src/compute_temp_com.rst similarity index 100% rename from doc/rst/compute_temp_com.rst rename to doc/src/compute_temp_com.rst diff --git a/doc/rst/compute_temp_cs.rst b/doc/src/compute_temp_cs.rst similarity index 100% rename from doc/rst/compute_temp_cs.rst rename to doc/src/compute_temp_cs.rst diff --git a/doc/rst/compute_temp_deform.rst b/doc/src/compute_temp_deform.rst similarity index 100% rename from doc/rst/compute_temp_deform.rst rename to doc/src/compute_temp_deform.rst diff --git a/doc/rst/compute_temp_deform_eff.rst b/doc/src/compute_temp_deform_eff.rst similarity index 100% rename from doc/rst/compute_temp_deform_eff.rst rename to doc/src/compute_temp_deform_eff.rst diff --git a/doc/rst/compute_temp_drude.rst b/doc/src/compute_temp_drude.rst similarity index 100% rename from doc/rst/compute_temp_drude.rst rename to doc/src/compute_temp_drude.rst diff --git a/doc/rst/compute_temp_eff.rst b/doc/src/compute_temp_eff.rst similarity index 100% rename from doc/rst/compute_temp_eff.rst rename to doc/src/compute_temp_eff.rst diff --git a/doc/rst/compute_temp_partial.rst b/doc/src/compute_temp_partial.rst similarity index 100% rename from doc/rst/compute_temp_partial.rst rename to doc/src/compute_temp_partial.rst diff --git a/doc/rst/compute_temp_profile.rst b/doc/src/compute_temp_profile.rst similarity index 100% rename from doc/rst/compute_temp_profile.rst rename to doc/src/compute_temp_profile.rst diff --git a/doc/rst/compute_temp_ramp.rst b/doc/src/compute_temp_ramp.rst similarity index 100% rename from doc/rst/compute_temp_ramp.rst rename to doc/src/compute_temp_ramp.rst diff --git a/doc/rst/compute_temp_region.rst b/doc/src/compute_temp_region.rst similarity index 100% rename from doc/rst/compute_temp_region.rst rename to doc/src/compute_temp_region.rst diff --git a/doc/rst/compute_temp_region_eff.rst b/doc/src/compute_temp_region_eff.rst similarity index 100% rename from doc/rst/compute_temp_region_eff.rst rename to doc/src/compute_temp_region_eff.rst diff --git a/doc/rst/compute_temp_rotate.rst b/doc/src/compute_temp_rotate.rst similarity index 100% rename from doc/rst/compute_temp_rotate.rst rename to doc/src/compute_temp_rotate.rst diff --git a/doc/rst/compute_temp_sphere.rst b/doc/src/compute_temp_sphere.rst similarity index 100% rename from doc/rst/compute_temp_sphere.rst rename to doc/src/compute_temp_sphere.rst diff --git a/doc/rst/compute_temp_uef.rst b/doc/src/compute_temp_uef.rst similarity index 100% rename from doc/rst/compute_temp_uef.rst rename to doc/src/compute_temp_uef.rst diff --git a/doc/rst/compute_ti.rst b/doc/src/compute_ti.rst similarity index 100% rename from doc/rst/compute_ti.rst rename to doc/src/compute_ti.rst diff --git a/doc/rst/compute_torque_chunk.rst b/doc/src/compute_torque_chunk.rst similarity index 100% rename from doc/rst/compute_torque_chunk.rst rename to doc/src/compute_torque_chunk.rst diff --git a/doc/rst/compute_vacf.rst b/doc/src/compute_vacf.rst similarity index 100% rename from doc/rst/compute_vacf.rst rename to doc/src/compute_vacf.rst diff --git a/doc/rst/compute_vcm_chunk.rst b/doc/src/compute_vcm_chunk.rst similarity index 100% rename from doc/rst/compute_vcm_chunk.rst rename to doc/src/compute_vcm_chunk.rst diff --git a/doc/rst/compute_voronoi_atom.rst b/doc/src/compute_voronoi_atom.rst similarity index 100% rename from doc/rst/compute_voronoi_atom.rst rename to doc/src/compute_voronoi_atom.rst diff --git a/doc/rst/compute_xrd.rst b/doc/src/compute_xrd.rst similarity index 100% rename from doc/rst/compute_xrd.rst rename to doc/src/compute_xrd.rst diff --git a/doc/rst/computes.rst b/doc/src/computes.rst similarity index 100% rename from doc/rst/computes.rst rename to doc/src/computes.rst diff --git a/doc/rst/create_atoms.rst b/doc/src/create_atoms.rst similarity index 100% rename from doc/rst/create_atoms.rst rename to doc/src/create_atoms.rst diff --git a/doc/rst/create_bonds.rst b/doc/src/create_bonds.rst similarity index 100% rename from doc/rst/create_bonds.rst rename to doc/src/create_bonds.rst diff --git a/doc/rst/create_box.rst b/doc/src/create_box.rst similarity index 100% rename from doc/rst/create_box.rst rename to doc/src/create_box.rst diff --git a/doc/rst/delete_atoms.rst b/doc/src/delete_atoms.rst similarity index 100% rename from doc/rst/delete_atoms.rst rename to doc/src/delete_atoms.rst diff --git a/doc/rst/delete_bonds.rst b/doc/src/delete_bonds.rst similarity index 100% rename from doc/rst/delete_bonds.rst rename to doc/src/delete_bonds.rst diff --git a/doc/rst/dielectric.rst b/doc/src/dielectric.rst similarity index 100% rename from doc/rst/dielectric.rst rename to doc/src/dielectric.rst diff --git a/doc/rst/dihedral_charmm.rst b/doc/src/dihedral_charmm.rst similarity index 100% rename from doc/rst/dihedral_charmm.rst rename to doc/src/dihedral_charmm.rst diff --git a/doc/rst/dihedral_class2.rst b/doc/src/dihedral_class2.rst similarity index 100% rename from doc/rst/dihedral_class2.rst rename to doc/src/dihedral_class2.rst diff --git a/doc/rst/dihedral_coeff.rst b/doc/src/dihedral_coeff.rst similarity index 100% rename from doc/rst/dihedral_coeff.rst rename to doc/src/dihedral_coeff.rst diff --git a/doc/rst/dihedral_cosine_shift_exp.rst b/doc/src/dihedral_cosine_shift_exp.rst similarity index 100% rename from doc/rst/dihedral_cosine_shift_exp.rst rename to doc/src/dihedral_cosine_shift_exp.rst diff --git a/doc/rst/dihedral_fourier.rst b/doc/src/dihedral_fourier.rst similarity index 100% rename from doc/rst/dihedral_fourier.rst rename to doc/src/dihedral_fourier.rst diff --git a/doc/rst/dihedral_harmonic.rst b/doc/src/dihedral_harmonic.rst similarity index 100% rename from doc/rst/dihedral_harmonic.rst rename to doc/src/dihedral_harmonic.rst diff --git a/doc/rst/dihedral_helix.rst b/doc/src/dihedral_helix.rst similarity index 100% rename from doc/rst/dihedral_helix.rst rename to doc/src/dihedral_helix.rst diff --git a/doc/rst/dihedral_hybrid.rst b/doc/src/dihedral_hybrid.rst similarity index 100% rename from doc/rst/dihedral_hybrid.rst rename to doc/src/dihedral_hybrid.rst diff --git a/doc/rst/dihedral_multi_harmonic.rst b/doc/src/dihedral_multi_harmonic.rst similarity index 100% rename from doc/rst/dihedral_multi_harmonic.rst rename to doc/src/dihedral_multi_harmonic.rst diff --git a/doc/rst/dihedral_nharmonic.rst b/doc/src/dihedral_nharmonic.rst similarity index 100% rename from doc/rst/dihedral_nharmonic.rst rename to doc/src/dihedral_nharmonic.rst diff --git a/doc/rst/dihedral_none.rst b/doc/src/dihedral_none.rst similarity index 100% rename from doc/rst/dihedral_none.rst rename to doc/src/dihedral_none.rst diff --git a/doc/rst/dihedral_opls.rst b/doc/src/dihedral_opls.rst similarity index 100% rename from doc/rst/dihedral_opls.rst rename to doc/src/dihedral_opls.rst diff --git a/doc/rst/dihedral_quadratic.rst b/doc/src/dihedral_quadratic.rst similarity index 100% rename from doc/rst/dihedral_quadratic.rst rename to doc/src/dihedral_quadratic.rst diff --git a/doc/rst/dihedral_spherical.rst b/doc/src/dihedral_spherical.rst similarity index 100% rename from doc/rst/dihedral_spherical.rst rename to doc/src/dihedral_spherical.rst diff --git a/doc/rst/dihedral_style.rst b/doc/src/dihedral_style.rst similarity index 100% rename from doc/rst/dihedral_style.rst rename to doc/src/dihedral_style.rst diff --git a/doc/rst/dihedral_table.rst b/doc/src/dihedral_table.rst similarity index 100% rename from doc/rst/dihedral_table.rst rename to doc/src/dihedral_table.rst diff --git a/doc/rst/dihedral_table_cut.rst b/doc/src/dihedral_table_cut.rst similarity index 100% rename from doc/rst/dihedral_table_cut.rst rename to doc/src/dihedral_table_cut.rst diff --git a/doc/rst/dihedral_zero.rst b/doc/src/dihedral_zero.rst similarity index 100% rename from doc/rst/dihedral_zero.rst rename to doc/src/dihedral_zero.rst diff --git a/doc/rst/dihedrals.rst b/doc/src/dihedrals.rst similarity index 100% rename from doc/rst/dihedrals.rst rename to doc/src/dihedrals.rst diff --git a/doc/rst/dimension.rst b/doc/src/dimension.rst similarity index 100% rename from doc/rst/dimension.rst rename to doc/src/dimension.rst diff --git a/doc/rst/displace_atoms.rst b/doc/src/displace_atoms.rst similarity index 100% rename from doc/rst/displace_atoms.rst rename to doc/src/displace_atoms.rst diff --git a/doc/rst/dump.rst b/doc/src/dump.rst similarity index 100% rename from doc/rst/dump.rst rename to doc/src/dump.rst diff --git a/doc/rst/dump_adios.rst b/doc/src/dump_adios.rst similarity index 100% rename from doc/rst/dump_adios.rst rename to doc/src/dump_adios.rst diff --git a/doc/rst/dump_cfg_uef.rst b/doc/src/dump_cfg_uef.rst similarity index 100% rename from doc/rst/dump_cfg_uef.rst rename to doc/src/dump_cfg_uef.rst diff --git a/doc/rst/dump_h5md.rst b/doc/src/dump_h5md.rst similarity index 100% rename from doc/rst/dump_h5md.rst rename to doc/src/dump_h5md.rst diff --git a/doc/rst/dump_image.rst b/doc/src/dump_image.rst similarity index 100% rename from doc/rst/dump_image.rst rename to doc/src/dump_image.rst diff --git a/doc/rst/dump_modify.rst b/doc/src/dump_modify.rst similarity index 100% rename from doc/rst/dump_modify.rst rename to doc/src/dump_modify.rst diff --git a/doc/rst/dump_molfile.rst b/doc/src/dump_molfile.rst similarity index 100% rename from doc/rst/dump_molfile.rst rename to doc/src/dump_molfile.rst diff --git a/doc/rst/dump_netcdf.rst b/doc/src/dump_netcdf.rst similarity index 100% rename from doc/rst/dump_netcdf.rst rename to doc/src/dump_netcdf.rst diff --git a/doc/rst/dump_vtk.rst b/doc/src/dump_vtk.rst similarity index 100% rename from doc/rst/dump_vtk.rst rename to doc/src/dump_vtk.rst diff --git a/doc/rst/dynamical_matrix.rst b/doc/src/dynamical_matrix.rst similarity index 100% rename from doc/rst/dynamical_matrix.rst rename to doc/src/dynamical_matrix.rst diff --git a/doc/rst/echo.rst b/doc/src/echo.rst similarity index 100% rename from doc/rst/echo.rst rename to doc/src/echo.rst diff --git a/doc/rst/fix.rst b/doc/src/fix.rst similarity index 100% rename from doc/rst/fix.rst rename to doc/src/fix.rst diff --git a/doc/rst/fix_adapt.rst b/doc/src/fix_adapt.rst similarity index 100% rename from doc/rst/fix_adapt.rst rename to doc/src/fix_adapt.rst diff --git a/doc/rst/fix_adapt_fep.rst b/doc/src/fix_adapt_fep.rst similarity index 100% rename from doc/rst/fix_adapt_fep.rst rename to doc/src/fix_adapt_fep.rst diff --git a/doc/rst/fix_addforce.rst b/doc/src/fix_addforce.rst similarity index 100% rename from doc/rst/fix_addforce.rst rename to doc/src/fix_addforce.rst diff --git a/doc/rst/fix_addtorque.rst b/doc/src/fix_addtorque.rst similarity index 100% rename from doc/rst/fix_addtorque.rst rename to doc/src/fix_addtorque.rst diff --git a/doc/rst/fix_append_atoms.rst b/doc/src/fix_append_atoms.rst similarity index 100% rename from doc/rst/fix_append_atoms.rst rename to doc/src/fix_append_atoms.rst diff --git a/doc/rst/fix_atc.rst b/doc/src/fix_atc.rst similarity index 100% rename from doc/rst/fix_atc.rst rename to doc/src/fix_atc.rst diff --git a/doc/rst/fix_atom_swap.rst b/doc/src/fix_atom_swap.rst similarity index 100% rename from doc/rst/fix_atom_swap.rst rename to doc/src/fix_atom_swap.rst diff --git a/doc/rst/fix_ave_atom.rst b/doc/src/fix_ave_atom.rst similarity index 100% rename from doc/rst/fix_ave_atom.rst rename to doc/src/fix_ave_atom.rst diff --git a/doc/rst/fix_ave_chunk.rst b/doc/src/fix_ave_chunk.rst similarity index 100% rename from doc/rst/fix_ave_chunk.rst rename to doc/src/fix_ave_chunk.rst diff --git a/doc/rst/fix_ave_correlate.rst b/doc/src/fix_ave_correlate.rst similarity index 100% rename from doc/rst/fix_ave_correlate.rst rename to doc/src/fix_ave_correlate.rst diff --git a/doc/rst/fix_ave_correlate_long.rst b/doc/src/fix_ave_correlate_long.rst similarity index 100% rename from doc/rst/fix_ave_correlate_long.rst rename to doc/src/fix_ave_correlate_long.rst diff --git a/doc/rst/fix_ave_histo.rst b/doc/src/fix_ave_histo.rst similarity index 100% rename from doc/rst/fix_ave_histo.rst rename to doc/src/fix_ave_histo.rst diff --git a/doc/rst/fix_ave_time.rst b/doc/src/fix_ave_time.rst similarity index 100% rename from doc/rst/fix_ave_time.rst rename to doc/src/fix_ave_time.rst diff --git a/doc/rst/fix_aveforce.rst b/doc/src/fix_aveforce.rst similarity index 100% rename from doc/rst/fix_aveforce.rst rename to doc/src/fix_aveforce.rst diff --git a/doc/rst/fix_balance.rst b/doc/src/fix_balance.rst similarity index 100% rename from doc/rst/fix_balance.rst rename to doc/src/fix_balance.rst diff --git a/doc/rst/fix_bocs.rst b/doc/src/fix_bocs.rst similarity index 100% rename from doc/rst/fix_bocs.rst rename to doc/src/fix_bocs.rst diff --git a/doc/rst/fix_bond_break.rst b/doc/src/fix_bond_break.rst similarity index 100% rename from doc/rst/fix_bond_break.rst rename to doc/src/fix_bond_break.rst diff --git a/doc/rst/fix_bond_create.rst b/doc/src/fix_bond_create.rst similarity index 100% rename from doc/rst/fix_bond_create.rst rename to doc/src/fix_bond_create.rst diff --git a/doc/rst/fix_bond_react.rst b/doc/src/fix_bond_react.rst similarity index 100% rename from doc/rst/fix_bond_react.rst rename to doc/src/fix_bond_react.rst diff --git a/doc/rst/fix_bond_swap.rst b/doc/src/fix_bond_swap.rst similarity index 100% rename from doc/rst/fix_bond_swap.rst rename to doc/src/fix_bond_swap.rst diff --git a/doc/rst/fix_box_relax.rst b/doc/src/fix_box_relax.rst similarity index 100% rename from doc/rst/fix_box_relax.rst rename to doc/src/fix_box_relax.rst diff --git a/doc/rst/fix_client_md.rst b/doc/src/fix_client_md.rst similarity index 100% rename from doc/rst/fix_client_md.rst rename to doc/src/fix_client_md.rst diff --git a/doc/rst/fix_cmap.rst b/doc/src/fix_cmap.rst similarity index 100% rename from doc/rst/fix_cmap.rst rename to doc/src/fix_cmap.rst diff --git a/doc/rst/fix_colvars.rst b/doc/src/fix_colvars.rst similarity index 100% rename from doc/rst/fix_colvars.rst rename to doc/src/fix_colvars.rst diff --git a/doc/rst/fix_controller.rst b/doc/src/fix_controller.rst similarity index 100% rename from doc/rst/fix_controller.rst rename to doc/src/fix_controller.rst diff --git a/doc/rst/fix_deform.rst b/doc/src/fix_deform.rst similarity index 100% rename from doc/rst/fix_deform.rst rename to doc/src/fix_deform.rst diff --git a/doc/rst/fix_deposit.rst b/doc/src/fix_deposit.rst similarity index 100% rename from doc/rst/fix_deposit.rst rename to doc/src/fix_deposit.rst diff --git a/doc/rst/fix_dpd_energy.rst b/doc/src/fix_dpd_energy.rst similarity index 100% rename from doc/rst/fix_dpd_energy.rst rename to doc/src/fix_dpd_energy.rst diff --git a/doc/rst/fix_dpd_source.rst b/doc/src/fix_dpd_source.rst similarity index 100% rename from doc/rst/fix_dpd_source.rst rename to doc/src/fix_dpd_source.rst diff --git a/doc/rst/fix_drag.rst b/doc/src/fix_drag.rst similarity index 100% rename from doc/rst/fix_drag.rst rename to doc/src/fix_drag.rst diff --git a/doc/rst/fix_drude.rst b/doc/src/fix_drude.rst similarity index 100% rename from doc/rst/fix_drude.rst rename to doc/src/fix_drude.rst diff --git a/doc/rst/fix_drude_transform.rst b/doc/src/fix_drude_transform.rst similarity index 100% rename from doc/rst/fix_drude_transform.rst rename to doc/src/fix_drude_transform.rst diff --git a/doc/rst/fix_dt_reset.rst b/doc/src/fix_dt_reset.rst similarity index 100% rename from doc/rst/fix_dt_reset.rst rename to doc/src/fix_dt_reset.rst diff --git a/doc/rst/fix_efield.rst b/doc/src/fix_efield.rst similarity index 100% rename from doc/rst/fix_efield.rst rename to doc/src/fix_efield.rst diff --git a/doc/rst/fix_ehex.rst b/doc/src/fix_ehex.rst similarity index 100% rename from doc/rst/fix_ehex.rst rename to doc/src/fix_ehex.rst diff --git a/doc/rst/fix_electron_stopping.rst b/doc/src/fix_electron_stopping.rst similarity index 100% rename from doc/rst/fix_electron_stopping.rst rename to doc/src/fix_electron_stopping.rst diff --git a/doc/rst/fix_enforce2d.rst b/doc/src/fix_enforce2d.rst similarity index 100% rename from doc/rst/fix_enforce2d.rst rename to doc/src/fix_enforce2d.rst diff --git a/doc/rst/fix_eos_cv.rst b/doc/src/fix_eos_cv.rst similarity index 100% rename from doc/rst/fix_eos_cv.rst rename to doc/src/fix_eos_cv.rst diff --git a/doc/rst/fix_eos_table.rst b/doc/src/fix_eos_table.rst similarity index 100% rename from doc/rst/fix_eos_table.rst rename to doc/src/fix_eos_table.rst diff --git a/doc/rst/fix_eos_table_rx.rst b/doc/src/fix_eos_table_rx.rst similarity index 100% rename from doc/rst/fix_eos_table_rx.rst rename to doc/src/fix_eos_table_rx.rst diff --git a/doc/rst/fix_evaporate.rst b/doc/src/fix_evaporate.rst similarity index 100% rename from doc/rst/fix_evaporate.rst rename to doc/src/fix_evaporate.rst diff --git a/doc/rst/fix_external.rst b/doc/src/fix_external.rst similarity index 100% rename from doc/rst/fix_external.rst rename to doc/src/fix_external.rst diff --git a/doc/rst/fix_ffl.rst b/doc/src/fix_ffl.rst similarity index 100% rename from doc/rst/fix_ffl.rst rename to doc/src/fix_ffl.rst diff --git a/doc/rst/fix_filter_corotate.rst b/doc/src/fix_filter_corotate.rst similarity index 100% rename from doc/rst/fix_filter_corotate.rst rename to doc/src/fix_filter_corotate.rst diff --git a/doc/rst/fix_flow_gauss.rst b/doc/src/fix_flow_gauss.rst similarity index 100% rename from doc/rst/fix_flow_gauss.rst rename to doc/src/fix_flow_gauss.rst diff --git a/doc/rst/fix_freeze.rst b/doc/src/fix_freeze.rst similarity index 100% rename from doc/rst/fix_freeze.rst rename to doc/src/fix_freeze.rst diff --git a/doc/rst/fix_gcmc.rst b/doc/src/fix_gcmc.rst similarity index 100% rename from doc/rst/fix_gcmc.rst rename to doc/src/fix_gcmc.rst diff --git a/doc/rst/fix_gld.rst b/doc/src/fix_gld.rst similarity index 100% rename from doc/rst/fix_gld.rst rename to doc/src/fix_gld.rst diff --git a/doc/rst/fix_gle.rst b/doc/src/fix_gle.rst similarity index 100% rename from doc/rst/fix_gle.rst rename to doc/src/fix_gle.rst diff --git a/doc/rst/fix_gravity.rst b/doc/src/fix_gravity.rst similarity index 100% rename from doc/rst/fix_gravity.rst rename to doc/src/fix_gravity.rst diff --git a/doc/rst/fix_grem.rst b/doc/src/fix_grem.rst similarity index 100% rename from doc/rst/fix_grem.rst rename to doc/src/fix_grem.rst diff --git a/doc/rst/fix_halt.rst b/doc/src/fix_halt.rst similarity index 100% rename from doc/rst/fix_halt.rst rename to doc/src/fix_halt.rst diff --git a/doc/rst/fix_heat.rst b/doc/src/fix_heat.rst similarity index 100% rename from doc/rst/fix_heat.rst rename to doc/src/fix_heat.rst diff --git a/doc/rst/fix_hyper_global.rst b/doc/src/fix_hyper_global.rst similarity index 100% rename from doc/rst/fix_hyper_global.rst rename to doc/src/fix_hyper_global.rst diff --git a/doc/rst/fix_hyper_local.rst b/doc/src/fix_hyper_local.rst similarity index 100% rename from doc/rst/fix_hyper_local.rst rename to doc/src/fix_hyper_local.rst diff --git a/doc/rst/fix_imd.rst b/doc/src/fix_imd.rst similarity index 100% rename from doc/rst/fix_imd.rst rename to doc/src/fix_imd.rst diff --git a/doc/rst/fix_indent.rst b/doc/src/fix_indent.rst similarity index 100% rename from doc/rst/fix_indent.rst rename to doc/src/fix_indent.rst diff --git a/doc/rst/fix_ipi.rst b/doc/src/fix_ipi.rst similarity index 100% rename from doc/rst/fix_ipi.rst rename to doc/src/fix_ipi.rst diff --git a/doc/rst/fix_langevin.rst b/doc/src/fix_langevin.rst similarity index 100% rename from doc/rst/fix_langevin.rst rename to doc/src/fix_langevin.rst diff --git a/doc/rst/fix_langevin_drude.rst b/doc/src/fix_langevin_drude.rst similarity index 100% rename from doc/rst/fix_langevin_drude.rst rename to doc/src/fix_langevin_drude.rst diff --git a/doc/rst/fix_langevin_eff.rst b/doc/src/fix_langevin_eff.rst similarity index 100% rename from doc/rst/fix_langevin_eff.rst rename to doc/src/fix_langevin_eff.rst diff --git a/doc/rst/fix_langevin_spin.rst b/doc/src/fix_langevin_spin.rst similarity index 100% rename from doc/rst/fix_langevin_spin.rst rename to doc/src/fix_langevin_spin.rst diff --git a/doc/rst/fix_latte.rst b/doc/src/fix_latte.rst similarity index 100% rename from doc/rst/fix_latte.rst rename to doc/src/fix_latte.rst diff --git a/doc/rst/fix_lb_fluid.rst b/doc/src/fix_lb_fluid.rst similarity index 100% rename from doc/rst/fix_lb_fluid.rst rename to doc/src/fix_lb_fluid.rst diff --git a/doc/rst/fix_lb_momentum.rst b/doc/src/fix_lb_momentum.rst similarity index 100% rename from doc/rst/fix_lb_momentum.rst rename to doc/src/fix_lb_momentum.rst diff --git a/doc/rst/fix_lb_pc.rst b/doc/src/fix_lb_pc.rst similarity index 100% rename from doc/rst/fix_lb_pc.rst rename to doc/src/fix_lb_pc.rst diff --git a/doc/rst/fix_lb_rigid_pc_sphere.rst b/doc/src/fix_lb_rigid_pc_sphere.rst similarity index 100% rename from doc/rst/fix_lb_rigid_pc_sphere.rst rename to doc/src/fix_lb_rigid_pc_sphere.rst diff --git a/doc/rst/fix_lb_viscous.rst b/doc/src/fix_lb_viscous.rst similarity index 100% rename from doc/rst/fix_lb_viscous.rst rename to doc/src/fix_lb_viscous.rst diff --git a/doc/rst/fix_lineforce.rst b/doc/src/fix_lineforce.rst similarity index 100% rename from doc/rst/fix_lineforce.rst rename to doc/src/fix_lineforce.rst diff --git a/doc/rst/fix_manifoldforce.rst b/doc/src/fix_manifoldforce.rst similarity index 100% rename from doc/rst/fix_manifoldforce.rst rename to doc/src/fix_manifoldforce.rst diff --git a/doc/rst/fix_meso.rst b/doc/src/fix_meso.rst similarity index 100% rename from doc/rst/fix_meso.rst rename to doc/src/fix_meso.rst diff --git a/doc/rst/fix_meso_move.rst b/doc/src/fix_meso_move.rst similarity index 100% rename from doc/rst/fix_meso_move.rst rename to doc/src/fix_meso_move.rst diff --git a/doc/rst/fix_meso_stationary.rst b/doc/src/fix_meso_stationary.rst similarity index 100% rename from doc/rst/fix_meso_stationary.rst rename to doc/src/fix_meso_stationary.rst diff --git a/doc/rst/fix_modify.rst b/doc/src/fix_modify.rst similarity index 100% rename from doc/rst/fix_modify.rst rename to doc/src/fix_modify.rst diff --git a/doc/rst/fix_momentum.rst b/doc/src/fix_momentum.rst similarity index 100% rename from doc/rst/fix_momentum.rst rename to doc/src/fix_momentum.rst diff --git a/doc/rst/fix_move.rst b/doc/src/fix_move.rst similarity index 100% rename from doc/rst/fix_move.rst rename to doc/src/fix_move.rst diff --git a/doc/rst/fix_mscg.rst b/doc/src/fix_mscg.rst similarity index 100% rename from doc/rst/fix_mscg.rst rename to doc/src/fix_mscg.rst diff --git a/doc/rst/fix_msst.rst b/doc/src/fix_msst.rst similarity index 100% rename from doc/rst/fix_msst.rst rename to doc/src/fix_msst.rst diff --git a/doc/rst/fix_mvv_dpd.rst b/doc/src/fix_mvv_dpd.rst similarity index 100% rename from doc/rst/fix_mvv_dpd.rst rename to doc/src/fix_mvv_dpd.rst diff --git a/doc/rst/fix_neb.rst b/doc/src/fix_neb.rst similarity index 100% rename from doc/rst/fix_neb.rst rename to doc/src/fix_neb.rst diff --git a/doc/rst/fix_neb_spin.rst b/doc/src/fix_neb_spin.rst similarity index 100% rename from doc/rst/fix_neb_spin.rst rename to doc/src/fix_neb_spin.rst diff --git a/doc/rst/fix_nh.rst b/doc/src/fix_nh.rst similarity index 100% rename from doc/rst/fix_nh.rst rename to doc/src/fix_nh.rst diff --git a/doc/rst/fix_nh_eff.rst b/doc/src/fix_nh_eff.rst similarity index 100% rename from doc/rst/fix_nh_eff.rst rename to doc/src/fix_nh_eff.rst diff --git a/doc/rst/fix_nh_uef.rst b/doc/src/fix_nh_uef.rst similarity index 100% rename from doc/rst/fix_nh_uef.rst rename to doc/src/fix_nh_uef.rst diff --git a/doc/rst/fix_nph_asphere.rst b/doc/src/fix_nph_asphere.rst similarity index 100% rename from doc/rst/fix_nph_asphere.rst rename to doc/src/fix_nph_asphere.rst diff --git a/doc/rst/fix_nph_body.rst b/doc/src/fix_nph_body.rst similarity index 100% rename from doc/rst/fix_nph_body.rst rename to doc/src/fix_nph_body.rst diff --git a/doc/rst/fix_nph_sphere.rst b/doc/src/fix_nph_sphere.rst similarity index 100% rename from doc/rst/fix_nph_sphere.rst rename to doc/src/fix_nph_sphere.rst diff --git a/doc/rst/fix_nphug.rst b/doc/src/fix_nphug.rst similarity index 100% rename from doc/rst/fix_nphug.rst rename to doc/src/fix_nphug.rst diff --git a/doc/rst/fix_npt_asphere.rst b/doc/src/fix_npt_asphere.rst similarity index 100% rename from doc/rst/fix_npt_asphere.rst rename to doc/src/fix_npt_asphere.rst diff --git a/doc/rst/fix_npt_body.rst b/doc/src/fix_npt_body.rst similarity index 100% rename from doc/rst/fix_npt_body.rst rename to doc/src/fix_npt_body.rst diff --git a/doc/rst/fix_npt_sphere.rst b/doc/src/fix_npt_sphere.rst similarity index 100% rename from doc/rst/fix_npt_sphere.rst rename to doc/src/fix_npt_sphere.rst diff --git a/doc/rst/fix_nve.rst b/doc/src/fix_nve.rst similarity index 100% rename from doc/rst/fix_nve.rst rename to doc/src/fix_nve.rst diff --git a/doc/rst/fix_nve_asphere.rst b/doc/src/fix_nve_asphere.rst similarity index 100% rename from doc/rst/fix_nve_asphere.rst rename to doc/src/fix_nve_asphere.rst diff --git a/doc/rst/fix_nve_asphere_noforce.rst b/doc/src/fix_nve_asphere_noforce.rst similarity index 100% rename from doc/rst/fix_nve_asphere_noforce.rst rename to doc/src/fix_nve_asphere_noforce.rst diff --git a/doc/rst/fix_nve_awpmd.rst b/doc/src/fix_nve_awpmd.rst similarity index 100% rename from doc/rst/fix_nve_awpmd.rst rename to doc/src/fix_nve_awpmd.rst diff --git a/doc/rst/fix_nve_body.rst b/doc/src/fix_nve_body.rst similarity index 100% rename from doc/rst/fix_nve_body.rst rename to doc/src/fix_nve_body.rst diff --git a/doc/rst/fix_nve_dot.rst b/doc/src/fix_nve_dot.rst similarity index 100% rename from doc/rst/fix_nve_dot.rst rename to doc/src/fix_nve_dot.rst diff --git a/doc/rst/fix_nve_dotc_langevin.rst b/doc/src/fix_nve_dotc_langevin.rst similarity index 100% rename from doc/rst/fix_nve_dotc_langevin.rst rename to doc/src/fix_nve_dotc_langevin.rst diff --git a/doc/rst/fix_nve_eff.rst b/doc/src/fix_nve_eff.rst similarity index 100% rename from doc/rst/fix_nve_eff.rst rename to doc/src/fix_nve_eff.rst diff --git a/doc/rst/fix_nve_limit.rst b/doc/src/fix_nve_limit.rst similarity index 100% rename from doc/rst/fix_nve_limit.rst rename to doc/src/fix_nve_limit.rst diff --git a/doc/rst/fix_nve_line.rst b/doc/src/fix_nve_line.rst similarity index 100% rename from doc/rst/fix_nve_line.rst rename to doc/src/fix_nve_line.rst diff --git a/doc/rst/fix_nve_manifold_rattle.rst b/doc/src/fix_nve_manifold_rattle.rst similarity index 100% rename from doc/rst/fix_nve_manifold_rattle.rst rename to doc/src/fix_nve_manifold_rattle.rst diff --git a/doc/rst/fix_nve_noforce.rst b/doc/src/fix_nve_noforce.rst similarity index 100% rename from doc/rst/fix_nve_noforce.rst rename to doc/src/fix_nve_noforce.rst diff --git a/doc/rst/fix_nve_sphere.rst b/doc/src/fix_nve_sphere.rst similarity index 100% rename from doc/rst/fix_nve_sphere.rst rename to doc/src/fix_nve_sphere.rst diff --git a/doc/rst/fix_nve_spin.rst b/doc/src/fix_nve_spin.rst similarity index 100% rename from doc/rst/fix_nve_spin.rst rename to doc/src/fix_nve_spin.rst diff --git a/doc/rst/fix_nve_tri.rst b/doc/src/fix_nve_tri.rst similarity index 100% rename from doc/rst/fix_nve_tri.rst rename to doc/src/fix_nve_tri.rst diff --git a/doc/rst/fix_nvk.rst b/doc/src/fix_nvk.rst similarity index 100% rename from doc/rst/fix_nvk.rst rename to doc/src/fix_nvk.rst diff --git a/doc/rst/fix_nvt_asphere.rst b/doc/src/fix_nvt_asphere.rst similarity index 100% rename from doc/rst/fix_nvt_asphere.rst rename to doc/src/fix_nvt_asphere.rst diff --git a/doc/rst/fix_nvt_body.rst b/doc/src/fix_nvt_body.rst similarity index 100% rename from doc/rst/fix_nvt_body.rst rename to doc/src/fix_nvt_body.rst diff --git a/doc/rst/fix_nvt_manifold_rattle.rst b/doc/src/fix_nvt_manifold_rattle.rst similarity index 100% rename from doc/rst/fix_nvt_manifold_rattle.rst rename to doc/src/fix_nvt_manifold_rattle.rst diff --git a/doc/rst/fix_nvt_sllod.rst b/doc/src/fix_nvt_sllod.rst similarity index 100% rename from doc/rst/fix_nvt_sllod.rst rename to doc/src/fix_nvt_sllod.rst diff --git a/doc/rst/fix_nvt_sllod_eff.rst b/doc/src/fix_nvt_sllod_eff.rst similarity index 100% rename from doc/rst/fix_nvt_sllod_eff.rst rename to doc/src/fix_nvt_sllod_eff.rst diff --git a/doc/rst/fix_nvt_sphere.rst b/doc/src/fix_nvt_sphere.rst similarity index 100% rename from doc/rst/fix_nvt_sphere.rst rename to doc/src/fix_nvt_sphere.rst diff --git a/doc/rst/fix_oneway.rst b/doc/src/fix_oneway.rst similarity index 100% rename from doc/rst/fix_oneway.rst rename to doc/src/fix_oneway.rst diff --git a/doc/rst/fix_orient.rst b/doc/src/fix_orient.rst similarity index 100% rename from doc/rst/fix_orient.rst rename to doc/src/fix_orient.rst diff --git a/doc/rst/fix_phonon.rst b/doc/src/fix_phonon.rst similarity index 100% rename from doc/rst/fix_phonon.rst rename to doc/src/fix_phonon.rst diff --git a/doc/rst/fix_pimd.rst b/doc/src/fix_pimd.rst similarity index 100% rename from doc/rst/fix_pimd.rst rename to doc/src/fix_pimd.rst diff --git a/doc/rst/fix_planeforce.rst b/doc/src/fix_planeforce.rst similarity index 100% rename from doc/rst/fix_planeforce.rst rename to doc/src/fix_planeforce.rst diff --git a/doc/rst/fix_plumed.rst b/doc/src/fix_plumed.rst similarity index 100% rename from doc/rst/fix_plumed.rst rename to doc/src/fix_plumed.rst diff --git a/doc/rst/fix_poems.rst b/doc/src/fix_poems.rst similarity index 100% rename from doc/rst/fix_poems.rst rename to doc/src/fix_poems.rst diff --git a/doc/rst/fix_pour.rst b/doc/src/fix_pour.rst similarity index 100% rename from doc/rst/fix_pour.rst rename to doc/src/fix_pour.rst diff --git a/doc/rst/fix_precession_spin.rst b/doc/src/fix_precession_spin.rst similarity index 100% rename from doc/rst/fix_precession_spin.rst rename to doc/src/fix_precession_spin.rst diff --git a/doc/rst/fix_press_berendsen.rst b/doc/src/fix_press_berendsen.rst similarity index 100% rename from doc/rst/fix_press_berendsen.rst rename to doc/src/fix_press_berendsen.rst diff --git a/doc/rst/fix_print.rst b/doc/src/fix_print.rst similarity index 100% rename from doc/rst/fix_print.rst rename to doc/src/fix_print.rst diff --git a/doc/rst/fix_property_atom.rst b/doc/src/fix_property_atom.rst similarity index 100% rename from doc/rst/fix_property_atom.rst rename to doc/src/fix_property_atom.rst diff --git a/doc/rst/fix_python_invoke.rst b/doc/src/fix_python_invoke.rst similarity index 100% rename from doc/rst/fix_python_invoke.rst rename to doc/src/fix_python_invoke.rst diff --git a/doc/rst/fix_python_move.rst b/doc/src/fix_python_move.rst similarity index 100% rename from doc/rst/fix_python_move.rst rename to doc/src/fix_python_move.rst diff --git a/doc/rst/fix_qbmsst.rst b/doc/src/fix_qbmsst.rst similarity index 100% rename from doc/rst/fix_qbmsst.rst rename to doc/src/fix_qbmsst.rst diff --git a/doc/rst/fix_qeq.rst b/doc/src/fix_qeq.rst similarity index 100% rename from doc/rst/fix_qeq.rst rename to doc/src/fix_qeq.rst diff --git a/doc/rst/fix_qeq_comb.rst b/doc/src/fix_qeq_comb.rst similarity index 100% rename from doc/rst/fix_qeq_comb.rst rename to doc/src/fix_qeq_comb.rst diff --git a/doc/rst/fix_qeq_reax.rst b/doc/src/fix_qeq_reax.rst similarity index 100% rename from doc/rst/fix_qeq_reax.rst rename to doc/src/fix_qeq_reax.rst diff --git a/doc/rst/fix_qmmm.rst b/doc/src/fix_qmmm.rst similarity index 100% rename from doc/rst/fix_qmmm.rst rename to doc/src/fix_qmmm.rst diff --git a/doc/rst/fix_qtb.rst b/doc/src/fix_qtb.rst similarity index 100% rename from doc/rst/fix_qtb.rst rename to doc/src/fix_qtb.rst diff --git a/doc/rst/fix_reaxc_bonds.rst b/doc/src/fix_reaxc_bonds.rst similarity index 100% rename from doc/rst/fix_reaxc_bonds.rst rename to doc/src/fix_reaxc_bonds.rst diff --git a/doc/rst/fix_reaxc_species.rst b/doc/src/fix_reaxc_species.rst similarity index 100% rename from doc/rst/fix_reaxc_species.rst rename to doc/src/fix_reaxc_species.rst diff --git a/doc/rst/fix_recenter.rst b/doc/src/fix_recenter.rst similarity index 100% rename from doc/rst/fix_recenter.rst rename to doc/src/fix_recenter.rst diff --git a/doc/rst/fix_restrain.rst b/doc/src/fix_restrain.rst similarity index 100% rename from doc/rst/fix_restrain.rst rename to doc/src/fix_restrain.rst diff --git a/doc/rst/fix_rhok.rst b/doc/src/fix_rhok.rst similarity index 100% rename from doc/rst/fix_rhok.rst rename to doc/src/fix_rhok.rst diff --git a/doc/rst/fix_rigid.rst b/doc/src/fix_rigid.rst similarity index 100% rename from doc/rst/fix_rigid.rst rename to doc/src/fix_rigid.rst diff --git a/doc/rst/fix_rigid_meso.rst b/doc/src/fix_rigid_meso.rst similarity index 100% rename from doc/rst/fix_rigid_meso.rst rename to doc/src/fix_rigid_meso.rst diff --git a/doc/rst/fix_rx.rst b/doc/src/fix_rx.rst similarity index 100% rename from doc/rst/fix_rx.rst rename to doc/src/fix_rx.rst diff --git a/doc/rst/fix_saed_vtk.rst b/doc/src/fix_saed_vtk.rst similarity index 100% rename from doc/rst/fix_saed_vtk.rst rename to doc/src/fix_saed_vtk.rst diff --git a/doc/rst/fix_setforce.rst b/doc/src/fix_setforce.rst similarity index 100% rename from doc/rst/fix_setforce.rst rename to doc/src/fix_setforce.rst diff --git a/doc/rst/fix_shake.rst b/doc/src/fix_shake.rst similarity index 100% rename from doc/rst/fix_shake.rst rename to doc/src/fix_shake.rst diff --git a/doc/rst/fix_shardlow.rst b/doc/src/fix_shardlow.rst similarity index 100% rename from doc/rst/fix_shardlow.rst rename to doc/src/fix_shardlow.rst diff --git a/doc/rst/fix_smd.rst b/doc/src/fix_smd.rst similarity index 100% rename from doc/rst/fix_smd.rst rename to doc/src/fix_smd.rst diff --git a/doc/rst/fix_smd_adjust_dt.rst b/doc/src/fix_smd_adjust_dt.rst similarity index 100% rename from doc/rst/fix_smd_adjust_dt.rst rename to doc/src/fix_smd_adjust_dt.rst diff --git a/doc/rst/fix_smd_integrate_tlsph.rst b/doc/src/fix_smd_integrate_tlsph.rst similarity index 100% rename from doc/rst/fix_smd_integrate_tlsph.rst rename to doc/src/fix_smd_integrate_tlsph.rst diff --git a/doc/rst/fix_smd_integrate_ulsph.rst b/doc/src/fix_smd_integrate_ulsph.rst similarity index 100% rename from doc/rst/fix_smd_integrate_ulsph.rst rename to doc/src/fix_smd_integrate_ulsph.rst diff --git a/doc/rst/fix_smd_move_triangulated_surface.rst b/doc/src/fix_smd_move_triangulated_surface.rst similarity index 100% rename from doc/rst/fix_smd_move_triangulated_surface.rst rename to doc/src/fix_smd_move_triangulated_surface.rst diff --git a/doc/rst/fix_smd_setvel.rst b/doc/src/fix_smd_setvel.rst similarity index 100% rename from doc/rst/fix_smd_setvel.rst rename to doc/src/fix_smd_setvel.rst diff --git a/doc/rst/fix_smd_wall_surface.rst b/doc/src/fix_smd_wall_surface.rst similarity index 100% rename from doc/rst/fix_smd_wall_surface.rst rename to doc/src/fix_smd_wall_surface.rst diff --git a/doc/rst/fix_spring.rst b/doc/src/fix_spring.rst similarity index 100% rename from doc/rst/fix_spring.rst rename to doc/src/fix_spring.rst diff --git a/doc/rst/fix_spring_chunk.rst b/doc/src/fix_spring_chunk.rst similarity index 100% rename from doc/rst/fix_spring_chunk.rst rename to doc/src/fix_spring_chunk.rst diff --git a/doc/rst/fix_spring_rg.rst b/doc/src/fix_spring_rg.rst similarity index 100% rename from doc/rst/fix_spring_rg.rst rename to doc/src/fix_spring_rg.rst diff --git a/doc/rst/fix_spring_self.rst b/doc/src/fix_spring_self.rst similarity index 100% rename from doc/rst/fix_spring_self.rst rename to doc/src/fix_spring_self.rst diff --git a/doc/rst/fix_srd.rst b/doc/src/fix_srd.rst similarity index 100% rename from doc/rst/fix_srd.rst rename to doc/src/fix_srd.rst diff --git a/doc/rst/fix_store_force.rst b/doc/src/fix_store_force.rst similarity index 100% rename from doc/rst/fix_store_force.rst rename to doc/src/fix_store_force.rst diff --git a/doc/rst/fix_store_state.rst b/doc/src/fix_store_state.rst similarity index 100% rename from doc/rst/fix_store_state.rst rename to doc/src/fix_store_state.rst diff --git a/doc/rst/fix_temp_berendsen.rst b/doc/src/fix_temp_berendsen.rst similarity index 100% rename from doc/rst/fix_temp_berendsen.rst rename to doc/src/fix_temp_berendsen.rst diff --git a/doc/rst/fix_temp_csvr.rst b/doc/src/fix_temp_csvr.rst similarity index 100% rename from doc/rst/fix_temp_csvr.rst rename to doc/src/fix_temp_csvr.rst diff --git a/doc/rst/fix_temp_rescale.rst b/doc/src/fix_temp_rescale.rst similarity index 100% rename from doc/rst/fix_temp_rescale.rst rename to doc/src/fix_temp_rescale.rst diff --git a/doc/rst/fix_temp_rescale_eff.rst b/doc/src/fix_temp_rescale_eff.rst similarity index 100% rename from doc/rst/fix_temp_rescale_eff.rst rename to doc/src/fix_temp_rescale_eff.rst diff --git a/doc/rst/fix_tfmc.rst b/doc/src/fix_tfmc.rst similarity index 100% rename from doc/rst/fix_tfmc.rst rename to doc/src/fix_tfmc.rst diff --git a/doc/rst/fix_thermal_conductivity.rst b/doc/src/fix_thermal_conductivity.rst similarity index 100% rename from doc/rst/fix_thermal_conductivity.rst rename to doc/src/fix_thermal_conductivity.rst diff --git a/doc/rst/fix_ti_spring.rst b/doc/src/fix_ti_spring.rst similarity index 100% rename from doc/rst/fix_ti_spring.rst rename to doc/src/fix_ti_spring.rst diff --git a/doc/rst/fix_tmd.rst b/doc/src/fix_tmd.rst similarity index 100% rename from doc/rst/fix_tmd.rst rename to doc/src/fix_tmd.rst diff --git a/doc/rst/fix_ttm.rst b/doc/src/fix_ttm.rst similarity index 100% rename from doc/rst/fix_ttm.rst rename to doc/src/fix_ttm.rst diff --git a/doc/rst/fix_tune_kspace.rst b/doc/src/fix_tune_kspace.rst similarity index 100% rename from doc/rst/fix_tune_kspace.rst rename to doc/src/fix_tune_kspace.rst diff --git a/doc/rst/fix_vector.rst b/doc/src/fix_vector.rst similarity index 100% rename from doc/rst/fix_vector.rst rename to doc/src/fix_vector.rst diff --git a/doc/rst/fix_viscosity.rst b/doc/src/fix_viscosity.rst similarity index 100% rename from doc/rst/fix_viscosity.rst rename to doc/src/fix_viscosity.rst diff --git a/doc/rst/fix_viscous.rst b/doc/src/fix_viscous.rst similarity index 100% rename from doc/rst/fix_viscous.rst rename to doc/src/fix_viscous.rst diff --git a/doc/rst/fix_wall.rst b/doc/src/fix_wall.rst similarity index 100% rename from doc/rst/fix_wall.rst rename to doc/src/fix_wall.rst diff --git a/doc/rst/fix_wall_body_polygon.rst b/doc/src/fix_wall_body_polygon.rst similarity index 100% rename from doc/rst/fix_wall_body_polygon.rst rename to doc/src/fix_wall_body_polygon.rst diff --git a/doc/rst/fix_wall_body_polyhedron.rst b/doc/src/fix_wall_body_polyhedron.rst similarity index 100% rename from doc/rst/fix_wall_body_polyhedron.rst rename to doc/src/fix_wall_body_polyhedron.rst diff --git a/doc/rst/fix_wall_ees.rst b/doc/src/fix_wall_ees.rst similarity index 100% rename from doc/rst/fix_wall_ees.rst rename to doc/src/fix_wall_ees.rst diff --git a/doc/rst/fix_wall_gran.rst b/doc/src/fix_wall_gran.rst similarity index 100% rename from doc/rst/fix_wall_gran.rst rename to doc/src/fix_wall_gran.rst diff --git a/doc/rst/fix_wall_gran_region.rst b/doc/src/fix_wall_gran_region.rst similarity index 100% rename from doc/rst/fix_wall_gran_region.rst rename to doc/src/fix_wall_gran_region.rst diff --git a/doc/rst/fix_wall_piston.rst b/doc/src/fix_wall_piston.rst similarity index 100% rename from doc/rst/fix_wall_piston.rst rename to doc/src/fix_wall_piston.rst diff --git a/doc/rst/fix_wall_reflect.rst b/doc/src/fix_wall_reflect.rst similarity index 100% rename from doc/rst/fix_wall_reflect.rst rename to doc/src/fix_wall_reflect.rst diff --git a/doc/rst/fix_wall_region.rst b/doc/src/fix_wall_region.rst similarity index 100% rename from doc/rst/fix_wall_region.rst rename to doc/src/fix_wall_region.rst diff --git a/doc/rst/fix_wall_srd.rst b/doc/src/fix_wall_srd.rst similarity index 100% rename from doc/rst/fix_wall_srd.rst rename to doc/src/fix_wall_srd.rst diff --git a/doc/rst/fixes.rst b/doc/src/fixes.rst similarity index 100% rename from doc/rst/fixes.rst rename to doc/src/fixes.rst diff --git a/doc/rst/group.rst b/doc/src/group.rst similarity index 100% rename from doc/rst/group.rst rename to doc/src/group.rst diff --git a/doc/rst/group2ndx.rst b/doc/src/group2ndx.rst similarity index 100% rename from doc/rst/group2ndx.rst rename to doc/src/group2ndx.rst diff --git a/doc/rst/hyper.rst b/doc/src/hyper.rst similarity index 100% rename from doc/rst/hyper.rst rename to doc/src/hyper.rst diff --git a/doc/rst/if.rst b/doc/src/if.rst similarity index 100% rename from doc/rst/if.rst rename to doc/src/if.rst diff --git a/doc/rst/improper_class2.rst b/doc/src/improper_class2.rst similarity index 100% rename from doc/rst/improper_class2.rst rename to doc/src/improper_class2.rst diff --git a/doc/rst/improper_coeff.rst b/doc/src/improper_coeff.rst similarity index 100% rename from doc/rst/improper_coeff.rst rename to doc/src/improper_coeff.rst diff --git a/doc/rst/improper_cossq.rst b/doc/src/improper_cossq.rst similarity index 100% rename from doc/rst/improper_cossq.rst rename to doc/src/improper_cossq.rst diff --git a/doc/rst/improper_cvff.rst b/doc/src/improper_cvff.rst similarity index 100% rename from doc/rst/improper_cvff.rst rename to doc/src/improper_cvff.rst diff --git a/doc/rst/improper_distance.rst b/doc/src/improper_distance.rst similarity index 100% rename from doc/rst/improper_distance.rst rename to doc/src/improper_distance.rst diff --git a/doc/rst/improper_distharm.rst b/doc/src/improper_distharm.rst similarity index 100% rename from doc/rst/improper_distharm.rst rename to doc/src/improper_distharm.rst diff --git a/doc/rst/improper_fourier.rst b/doc/src/improper_fourier.rst similarity index 100% rename from doc/rst/improper_fourier.rst rename to doc/src/improper_fourier.rst diff --git a/doc/rst/improper_harmonic.rst b/doc/src/improper_harmonic.rst similarity index 100% rename from doc/rst/improper_harmonic.rst rename to doc/src/improper_harmonic.rst diff --git a/doc/rst/improper_hybrid.rst b/doc/src/improper_hybrid.rst similarity index 100% rename from doc/rst/improper_hybrid.rst rename to doc/src/improper_hybrid.rst diff --git a/doc/rst/improper_inversion_harmonic.rst b/doc/src/improper_inversion_harmonic.rst similarity index 100% rename from doc/rst/improper_inversion_harmonic.rst rename to doc/src/improper_inversion_harmonic.rst diff --git a/doc/rst/improper_none.rst b/doc/src/improper_none.rst similarity index 100% rename from doc/rst/improper_none.rst rename to doc/src/improper_none.rst diff --git a/doc/rst/improper_ring.rst b/doc/src/improper_ring.rst similarity index 100% rename from doc/rst/improper_ring.rst rename to doc/src/improper_ring.rst diff --git a/doc/rst/improper_sqdistharm.rst b/doc/src/improper_sqdistharm.rst similarity index 100% rename from doc/rst/improper_sqdistharm.rst rename to doc/src/improper_sqdistharm.rst diff --git a/doc/rst/improper_style.rst b/doc/src/improper_style.rst similarity index 100% rename from doc/rst/improper_style.rst rename to doc/src/improper_style.rst diff --git a/doc/rst/improper_umbrella.rst b/doc/src/improper_umbrella.rst similarity index 100% rename from doc/rst/improper_umbrella.rst rename to doc/src/improper_umbrella.rst diff --git a/doc/rst/improper_zero.rst b/doc/src/improper_zero.rst similarity index 100% rename from doc/rst/improper_zero.rst rename to doc/src/improper_zero.rst diff --git a/doc/rst/impropers.rst b/doc/src/impropers.rst similarity index 100% rename from doc/rst/impropers.rst rename to doc/src/impropers.rst diff --git a/doc/rst/include.rst b/doc/src/include.rst similarity index 100% rename from doc/rst/include.rst rename to doc/src/include.rst diff --git a/doc/rst/info.rst b/doc/src/info.rst similarity index 100% rename from doc/rst/info.rst rename to doc/src/info.rst diff --git a/doc/rst/jump.rst b/doc/src/jump.rst similarity index 100% rename from doc/rst/jump.rst rename to doc/src/jump.rst diff --git a/doc/rst/kim_commands.rst b/doc/src/kim_commands.rst similarity index 100% rename from doc/rst/kim_commands.rst rename to doc/src/kim_commands.rst diff --git a/doc/rst/kspace_modify.rst b/doc/src/kspace_modify.rst similarity index 100% rename from doc/rst/kspace_modify.rst rename to doc/src/kspace_modify.rst diff --git a/doc/rst/kspace_style.rst b/doc/src/kspace_style.rst similarity index 100% rename from doc/rst/kspace_style.rst rename to doc/src/kspace_style.rst diff --git a/doc/rst/label.rst b/doc/src/label.rst similarity index 100% rename from doc/rst/label.rst rename to doc/src/label.rst diff --git a/doc/rst/lattice.rst b/doc/src/lattice.rst similarity index 100% rename from doc/rst/lattice.rst rename to doc/src/lattice.rst diff --git a/doc/rst/log.rst b/doc/src/log.rst similarity index 100% rename from doc/rst/log.rst rename to doc/src/log.rst diff --git a/doc/rst/mass.rst b/doc/src/mass.rst similarity index 100% rename from doc/rst/mass.rst rename to doc/src/mass.rst diff --git a/doc/rst/message.rst b/doc/src/message.rst similarity index 100% rename from doc/rst/message.rst rename to doc/src/message.rst diff --git a/doc/rst/min_modify.rst b/doc/src/min_modify.rst similarity index 100% rename from doc/rst/min_modify.rst rename to doc/src/min_modify.rst diff --git a/doc/rst/min_spin.rst b/doc/src/min_spin.rst similarity index 100% rename from doc/rst/min_spin.rst rename to doc/src/min_spin.rst diff --git a/doc/rst/min_style.rst b/doc/src/min_style.rst similarity index 100% rename from doc/rst/min_style.rst rename to doc/src/min_style.rst diff --git a/doc/rst/minimize.rst b/doc/src/minimize.rst similarity index 100% rename from doc/rst/minimize.rst rename to doc/src/minimize.rst diff --git a/doc/rst/molecule.rst b/doc/src/molecule.rst similarity index 100% rename from doc/rst/molecule.rst rename to doc/src/molecule.rst diff --git a/doc/rst/neb.rst b/doc/src/neb.rst similarity index 100% rename from doc/rst/neb.rst rename to doc/src/neb.rst diff --git a/doc/rst/neb_spin.rst b/doc/src/neb_spin.rst similarity index 100% rename from doc/rst/neb_spin.rst rename to doc/src/neb_spin.rst diff --git a/doc/rst/neigh_modify.rst b/doc/src/neigh_modify.rst similarity index 100% rename from doc/rst/neigh_modify.rst rename to doc/src/neigh_modify.rst diff --git a/doc/rst/neighbor.rst b/doc/src/neighbor.rst similarity index 100% rename from doc/rst/neighbor.rst rename to doc/src/neighbor.rst diff --git a/doc/rst/newton.rst b/doc/src/newton.rst similarity index 100% rename from doc/rst/newton.rst rename to doc/src/newton.rst diff --git a/doc/rst/next.rst b/doc/src/next.rst similarity index 100% rename from doc/rst/next.rst rename to doc/src/next.rst diff --git a/doc/rst/package.rst b/doc/src/package.rst similarity index 100% rename from doc/rst/package.rst rename to doc/src/package.rst diff --git a/doc/rst/pair_adp.rst b/doc/src/pair_adp.rst similarity index 100% rename from doc/rst/pair_adp.rst rename to doc/src/pair_adp.rst diff --git a/doc/rst/pair_agni.rst b/doc/src/pair_agni.rst similarity index 100% rename from doc/rst/pair_agni.rst rename to doc/src/pair_agni.rst diff --git a/doc/rst/pair_airebo.rst b/doc/src/pair_airebo.rst similarity index 100% rename from doc/rst/pair_airebo.rst rename to doc/src/pair_airebo.rst diff --git a/doc/rst/pair_atm.rst b/doc/src/pair_atm.rst similarity index 100% rename from doc/rst/pair_atm.rst rename to doc/src/pair_atm.rst diff --git a/doc/rst/pair_awpmd.rst b/doc/src/pair_awpmd.rst similarity index 100% rename from doc/rst/pair_awpmd.rst rename to doc/src/pair_awpmd.rst diff --git a/doc/rst/pair_beck.rst b/doc/src/pair_beck.rst similarity index 100% rename from doc/rst/pair_beck.rst rename to doc/src/pair_beck.rst diff --git a/doc/rst/pair_body_nparticle.rst b/doc/src/pair_body_nparticle.rst similarity index 100% rename from doc/rst/pair_body_nparticle.rst rename to doc/src/pair_body_nparticle.rst diff --git a/doc/rst/pair_body_rounded_polygon.rst b/doc/src/pair_body_rounded_polygon.rst similarity index 100% rename from doc/rst/pair_body_rounded_polygon.rst rename to doc/src/pair_body_rounded_polygon.rst diff --git a/doc/rst/pair_body_rounded_polyhedron.rst b/doc/src/pair_body_rounded_polyhedron.rst similarity index 100% rename from doc/rst/pair_body_rounded_polyhedron.rst rename to doc/src/pair_body_rounded_polyhedron.rst diff --git a/doc/rst/pair_bop.rst b/doc/src/pair_bop.rst similarity index 100% rename from doc/rst/pair_bop.rst rename to doc/src/pair_bop.rst diff --git a/doc/rst/pair_born.rst b/doc/src/pair_born.rst similarity index 100% rename from doc/rst/pair_born.rst rename to doc/src/pair_born.rst diff --git a/doc/rst/pair_brownian.rst b/doc/src/pair_brownian.rst similarity index 100% rename from doc/rst/pair_brownian.rst rename to doc/src/pair_brownian.rst diff --git a/doc/rst/pair_buck.rst b/doc/src/pair_buck.rst similarity index 100% rename from doc/rst/pair_buck.rst rename to doc/src/pair_buck.rst diff --git a/doc/rst/pair_buck6d_coul_gauss.rst b/doc/src/pair_buck6d_coul_gauss.rst similarity index 100% rename from doc/rst/pair_buck6d_coul_gauss.rst rename to doc/src/pair_buck6d_coul_gauss.rst diff --git a/doc/rst/pair_buck_long.rst b/doc/src/pair_buck_long.rst similarity index 100% rename from doc/rst/pair_buck_long.rst rename to doc/src/pair_buck_long.rst diff --git a/doc/rst/pair_charmm.rst b/doc/src/pair_charmm.rst similarity index 100% rename from doc/rst/pair_charmm.rst rename to doc/src/pair_charmm.rst diff --git a/doc/rst/pair_class2.rst b/doc/src/pair_class2.rst similarity index 100% rename from doc/rst/pair_class2.rst rename to doc/src/pair_class2.rst diff --git a/doc/rst/pair_coeff.rst b/doc/src/pair_coeff.rst similarity index 100% rename from doc/rst/pair_coeff.rst rename to doc/src/pair_coeff.rst diff --git a/doc/rst/pair_colloid.rst b/doc/src/pair_colloid.rst similarity index 100% rename from doc/rst/pair_colloid.rst rename to doc/src/pair_colloid.rst diff --git a/doc/rst/pair_comb.rst b/doc/src/pair_comb.rst similarity index 100% rename from doc/rst/pair_comb.rst rename to doc/src/pair_comb.rst diff --git a/doc/rst/pair_cosine_squared.rst b/doc/src/pair_cosine_squared.rst similarity index 100% rename from doc/rst/pair_cosine_squared.rst rename to doc/src/pair_cosine_squared.rst diff --git a/doc/rst/pair_coul.rst b/doc/src/pair_coul.rst similarity index 100% rename from doc/rst/pair_coul.rst rename to doc/src/pair_coul.rst diff --git a/doc/rst/pair_coul_diel.rst b/doc/src/pair_coul_diel.rst similarity index 100% rename from doc/rst/pair_coul_diel.rst rename to doc/src/pair_coul_diel.rst diff --git a/doc/rst/pair_coul_shield.rst b/doc/src/pair_coul_shield.rst similarity index 100% rename from doc/rst/pair_coul_shield.rst rename to doc/src/pair_coul_shield.rst diff --git a/doc/rst/pair_cs.rst b/doc/src/pair_cs.rst similarity index 100% rename from doc/rst/pair_cs.rst rename to doc/src/pair_cs.rst diff --git a/doc/rst/pair_dipole.rst b/doc/src/pair_dipole.rst similarity index 100% rename from doc/rst/pair_dipole.rst rename to doc/src/pair_dipole.rst diff --git a/doc/rst/pair_dpd.rst b/doc/src/pair_dpd.rst similarity index 100% rename from doc/rst/pair_dpd.rst rename to doc/src/pair_dpd.rst diff --git a/doc/rst/pair_dpd_fdt.rst b/doc/src/pair_dpd_fdt.rst similarity index 100% rename from doc/rst/pair_dpd_fdt.rst rename to doc/src/pair_dpd_fdt.rst diff --git a/doc/rst/pair_drip.rst b/doc/src/pair_drip.rst similarity index 100% rename from doc/rst/pair_drip.rst rename to doc/src/pair_drip.rst diff --git a/doc/rst/pair_dsmc.rst b/doc/src/pair_dsmc.rst similarity index 100% rename from doc/rst/pair_dsmc.rst rename to doc/src/pair_dsmc.rst diff --git a/doc/rst/pair_e3b.rst b/doc/src/pair_e3b.rst similarity index 100% rename from doc/rst/pair_e3b.rst rename to doc/src/pair_e3b.rst diff --git a/doc/rst/pair_eam.rst b/doc/src/pair_eam.rst similarity index 100% rename from doc/rst/pair_eam.rst rename to doc/src/pair_eam.rst diff --git a/doc/rst/pair_edip.rst b/doc/src/pair_edip.rst similarity index 100% rename from doc/rst/pair_edip.rst rename to doc/src/pair_edip.rst diff --git a/doc/rst/pair_eff.rst b/doc/src/pair_eff.rst similarity index 100% rename from doc/rst/pair_eff.rst rename to doc/src/pair_eff.rst diff --git a/doc/rst/pair_eim.rst b/doc/src/pair_eim.rst similarity index 100% rename from doc/rst/pair_eim.rst rename to doc/src/pair_eim.rst diff --git a/doc/rst/pair_exp6_rx.rst b/doc/src/pair_exp6_rx.rst similarity index 100% rename from doc/rst/pair_exp6_rx.rst rename to doc/src/pair_exp6_rx.rst diff --git a/doc/rst/pair_extep.rst b/doc/src/pair_extep.rst similarity index 100% rename from doc/rst/pair_extep.rst rename to doc/src/pair_extep.rst diff --git a/doc/rst/pair_fep_soft.rst b/doc/src/pair_fep_soft.rst similarity index 100% rename from doc/rst/pair_fep_soft.rst rename to doc/src/pair_fep_soft.rst diff --git a/doc/rst/pair_gauss.rst b/doc/src/pair_gauss.rst similarity index 100% rename from doc/rst/pair_gauss.rst rename to doc/src/pair_gauss.rst diff --git a/doc/rst/pair_gayberne.rst b/doc/src/pair_gayberne.rst similarity index 100% rename from doc/rst/pair_gayberne.rst rename to doc/src/pair_gayberne.rst diff --git a/doc/rst/pair_gran.rst b/doc/src/pair_gran.rst similarity index 100% rename from doc/rst/pair_gran.rst rename to doc/src/pair_gran.rst diff --git a/doc/rst/pair_granular.rst b/doc/src/pair_granular.rst similarity index 100% rename from doc/rst/pair_granular.rst rename to doc/src/pair_granular.rst diff --git a/doc/rst/pair_gromacs.rst b/doc/src/pair_gromacs.rst similarity index 100% rename from doc/rst/pair_gromacs.rst rename to doc/src/pair_gromacs.rst diff --git a/doc/rst/pair_gw.rst b/doc/src/pair_gw.rst similarity index 100% rename from doc/rst/pair_gw.rst rename to doc/src/pair_gw.rst diff --git a/doc/rst/pair_hbond_dreiding.rst b/doc/src/pair_hbond_dreiding.rst similarity index 100% rename from doc/rst/pair_hbond_dreiding.rst rename to doc/src/pair_hbond_dreiding.rst diff --git a/doc/rst/pair_hybrid.rst b/doc/src/pair_hybrid.rst similarity index 100% rename from doc/rst/pair_hybrid.rst rename to doc/src/pair_hybrid.rst diff --git a/doc/rst/pair_ilp_graphene_hbn.rst b/doc/src/pair_ilp_graphene_hbn.rst similarity index 100% rename from doc/rst/pair_ilp_graphene_hbn.rst rename to doc/src/pair_ilp_graphene_hbn.rst diff --git a/doc/rst/pair_kim.rst b/doc/src/pair_kim.rst similarity index 100% rename from doc/rst/pair_kim.rst rename to doc/src/pair_kim.rst diff --git a/doc/rst/pair_kolmogorov_crespi_full.rst b/doc/src/pair_kolmogorov_crespi_full.rst similarity index 100% rename from doc/rst/pair_kolmogorov_crespi_full.rst rename to doc/src/pair_kolmogorov_crespi_full.rst diff --git a/doc/rst/pair_kolmogorov_crespi_z.rst b/doc/src/pair_kolmogorov_crespi_z.rst similarity index 100% rename from doc/rst/pair_kolmogorov_crespi_z.rst rename to doc/src/pair_kolmogorov_crespi_z.rst diff --git a/doc/rst/pair_lcbop.rst b/doc/src/pair_lcbop.rst similarity index 100% rename from doc/rst/pair_lcbop.rst rename to doc/src/pair_lcbop.rst diff --git a/doc/rst/pair_lebedeva_z.rst b/doc/src/pair_lebedeva_z.rst similarity index 100% rename from doc/rst/pair_lebedeva_z.rst rename to doc/src/pair_lebedeva_z.rst diff --git a/doc/rst/pair_line_lj.rst b/doc/src/pair_line_lj.rst similarity index 100% rename from doc/rst/pair_line_lj.rst rename to doc/src/pair_line_lj.rst diff --git a/doc/rst/pair_list.rst b/doc/src/pair_list.rst similarity index 100% rename from doc/rst/pair_list.rst rename to doc/src/pair_list.rst diff --git a/doc/rst/pair_lj.rst b/doc/src/pair_lj.rst similarity index 100% rename from doc/rst/pair_lj.rst rename to doc/src/pair_lj.rst diff --git a/doc/rst/pair_lj96.rst b/doc/src/pair_lj96.rst similarity index 100% rename from doc/rst/pair_lj96.rst rename to doc/src/pair_lj96.rst diff --git a/doc/rst/pair_lj_cubic.rst b/doc/src/pair_lj_cubic.rst similarity index 100% rename from doc/rst/pair_lj_cubic.rst rename to doc/src/pair_lj_cubic.rst diff --git a/doc/rst/pair_lj_expand.rst b/doc/src/pair_lj_expand.rst similarity index 100% rename from doc/rst/pair_lj_expand.rst rename to doc/src/pair_lj_expand.rst diff --git a/doc/rst/pair_lj_long.rst b/doc/src/pair_lj_long.rst similarity index 100% rename from doc/rst/pair_lj_long.rst rename to doc/src/pair_lj_long.rst diff --git a/doc/rst/pair_lj_smooth.rst b/doc/src/pair_lj_smooth.rst similarity index 100% rename from doc/rst/pair_lj_smooth.rst rename to doc/src/pair_lj_smooth.rst diff --git a/doc/rst/pair_lj_smooth_linear.rst b/doc/src/pair_lj_smooth_linear.rst similarity index 100% rename from doc/rst/pair_lj_smooth_linear.rst rename to doc/src/pair_lj_smooth_linear.rst diff --git a/doc/rst/pair_lj_switch3_coulgauss.rst b/doc/src/pair_lj_switch3_coulgauss.rst similarity index 100% rename from doc/rst/pair_lj_switch3_coulgauss.rst rename to doc/src/pair_lj_switch3_coulgauss.rst diff --git a/doc/rst/pair_local_density.rst b/doc/src/pair_local_density.rst similarity index 100% rename from doc/rst/pair_local_density.rst rename to doc/src/pair_local_density.rst diff --git a/doc/rst/pair_lubricate.rst b/doc/src/pair_lubricate.rst similarity index 100% rename from doc/rst/pair_lubricate.rst rename to doc/src/pair_lubricate.rst diff --git a/doc/rst/pair_lubricateU.rst b/doc/src/pair_lubricateU.rst similarity index 100% rename from doc/rst/pair_lubricateU.rst rename to doc/src/pair_lubricateU.rst diff --git a/doc/rst/pair_mdf.rst b/doc/src/pair_mdf.rst similarity index 100% rename from doc/rst/pair_mdf.rst rename to doc/src/pair_mdf.rst diff --git a/doc/rst/pair_meam_spline.rst b/doc/src/pair_meam_spline.rst similarity index 100% rename from doc/rst/pair_meam_spline.rst rename to doc/src/pair_meam_spline.rst diff --git a/doc/rst/pair_meam_sw_spline.rst b/doc/src/pair_meam_sw_spline.rst similarity index 100% rename from doc/rst/pair_meam_sw_spline.rst rename to doc/src/pair_meam_sw_spline.rst diff --git a/doc/rst/pair_meamc.rst b/doc/src/pair_meamc.rst similarity index 100% rename from doc/rst/pair_meamc.rst rename to doc/src/pair_meamc.rst diff --git a/doc/rst/pair_meso.rst b/doc/src/pair_meso.rst similarity index 100% rename from doc/rst/pair_meso.rst rename to doc/src/pair_meso.rst diff --git a/doc/rst/pair_mgpt.rst b/doc/src/pair_mgpt.rst similarity index 100% rename from doc/rst/pair_mgpt.rst rename to doc/src/pair_mgpt.rst diff --git a/doc/rst/pair_mie.rst b/doc/src/pair_mie.rst similarity index 100% rename from doc/rst/pair_mie.rst rename to doc/src/pair_mie.rst diff --git a/doc/rst/pair_mm3_switch3_coulgauss.rst b/doc/src/pair_mm3_switch3_coulgauss.rst similarity index 100% rename from doc/rst/pair_mm3_switch3_coulgauss.rst rename to doc/src/pair_mm3_switch3_coulgauss.rst diff --git a/doc/rst/pair_modify.rst b/doc/src/pair_modify.rst similarity index 100% rename from doc/rst/pair_modify.rst rename to doc/src/pair_modify.rst diff --git a/doc/rst/pair_momb.rst b/doc/src/pair_momb.rst similarity index 100% rename from doc/rst/pair_momb.rst rename to doc/src/pair_momb.rst diff --git a/doc/rst/pair_morse.rst b/doc/src/pair_morse.rst similarity index 100% rename from doc/rst/pair_morse.rst rename to doc/src/pair_morse.rst diff --git a/doc/rst/pair_multi_lucy.rst b/doc/src/pair_multi_lucy.rst similarity index 100% rename from doc/rst/pair_multi_lucy.rst rename to doc/src/pair_multi_lucy.rst diff --git a/doc/rst/pair_multi_lucy_rx.rst b/doc/src/pair_multi_lucy_rx.rst similarity index 100% rename from doc/rst/pair_multi_lucy_rx.rst rename to doc/src/pair_multi_lucy_rx.rst diff --git a/doc/rst/pair_nb3b_harmonic.rst b/doc/src/pair_nb3b_harmonic.rst similarity index 100% rename from doc/rst/pair_nb3b_harmonic.rst rename to doc/src/pair_nb3b_harmonic.rst diff --git a/doc/rst/pair_nm.rst b/doc/src/pair_nm.rst similarity index 100% rename from doc/rst/pair_nm.rst rename to doc/src/pair_nm.rst diff --git a/doc/rst/pair_none.rst b/doc/src/pair_none.rst similarity index 100% rename from doc/rst/pair_none.rst rename to doc/src/pair_none.rst diff --git a/doc/rst/pair_oxdna.rst b/doc/src/pair_oxdna.rst similarity index 100% rename from doc/rst/pair_oxdna.rst rename to doc/src/pair_oxdna.rst diff --git a/doc/rst/pair_oxdna2.rst b/doc/src/pair_oxdna2.rst similarity index 100% rename from doc/rst/pair_oxdna2.rst rename to doc/src/pair_oxdna2.rst diff --git a/doc/rst/pair_peri.rst b/doc/src/pair_peri.rst similarity index 100% rename from doc/rst/pair_peri.rst rename to doc/src/pair_peri.rst diff --git a/doc/rst/pair_polymorphic.rst b/doc/src/pair_polymorphic.rst similarity index 100% rename from doc/rst/pair_polymorphic.rst rename to doc/src/pair_polymorphic.rst diff --git a/doc/rst/pair_python.rst b/doc/src/pair_python.rst similarity index 100% rename from doc/rst/pair_python.rst rename to doc/src/pair_python.rst diff --git a/doc/rst/pair_quip.rst b/doc/src/pair_quip.rst similarity index 100% rename from doc/rst/pair_quip.rst rename to doc/src/pair_quip.rst diff --git a/doc/rst/pair_reaxc.rst b/doc/src/pair_reaxc.rst similarity index 100% rename from doc/rst/pair_reaxc.rst rename to doc/src/pair_reaxc.rst diff --git a/doc/rst/pair_resquared.rst b/doc/src/pair_resquared.rst similarity index 100% rename from doc/rst/pair_resquared.rst rename to doc/src/pair_resquared.rst diff --git a/doc/rst/pair_sdk.rst b/doc/src/pair_sdk.rst similarity index 100% rename from doc/rst/pair_sdk.rst rename to doc/src/pair_sdk.rst diff --git a/doc/rst/pair_sdpd_taitwater_isothermal.rst b/doc/src/pair_sdpd_taitwater_isothermal.rst similarity index 100% rename from doc/rst/pair_sdpd_taitwater_isothermal.rst rename to doc/src/pair_sdpd_taitwater_isothermal.rst diff --git a/doc/rst/pair_smd_hertz.rst b/doc/src/pair_smd_hertz.rst similarity index 100% rename from doc/rst/pair_smd_hertz.rst rename to doc/src/pair_smd_hertz.rst diff --git a/doc/rst/pair_smd_tlsph.rst b/doc/src/pair_smd_tlsph.rst similarity index 100% rename from doc/rst/pair_smd_tlsph.rst rename to doc/src/pair_smd_tlsph.rst diff --git a/doc/rst/pair_smd_triangulated_surface.rst b/doc/src/pair_smd_triangulated_surface.rst similarity index 100% rename from doc/rst/pair_smd_triangulated_surface.rst rename to doc/src/pair_smd_triangulated_surface.rst diff --git a/doc/rst/pair_smd_ulsph.rst b/doc/src/pair_smd_ulsph.rst similarity index 100% rename from doc/rst/pair_smd_ulsph.rst rename to doc/src/pair_smd_ulsph.rst diff --git a/doc/rst/pair_smtbq.rst b/doc/src/pair_smtbq.rst similarity index 100% rename from doc/rst/pair_smtbq.rst rename to doc/src/pair_smtbq.rst diff --git a/doc/rst/pair_snap.rst b/doc/src/pair_snap.rst similarity index 100% rename from doc/rst/pair_snap.rst rename to doc/src/pair_snap.rst diff --git a/doc/rst/pair_soft.rst b/doc/src/pair_soft.rst similarity index 100% rename from doc/rst/pair_soft.rst rename to doc/src/pair_soft.rst diff --git a/doc/rst/pair_sph_heatconduction.rst b/doc/src/pair_sph_heatconduction.rst similarity index 100% rename from doc/rst/pair_sph_heatconduction.rst rename to doc/src/pair_sph_heatconduction.rst diff --git a/doc/rst/pair_sph_idealgas.rst b/doc/src/pair_sph_idealgas.rst similarity index 100% rename from doc/rst/pair_sph_idealgas.rst rename to doc/src/pair_sph_idealgas.rst diff --git a/doc/rst/pair_sph_lj.rst b/doc/src/pair_sph_lj.rst similarity index 100% rename from doc/rst/pair_sph_lj.rst rename to doc/src/pair_sph_lj.rst diff --git a/doc/rst/pair_sph_rhosum.rst b/doc/src/pair_sph_rhosum.rst similarity index 100% rename from doc/rst/pair_sph_rhosum.rst rename to doc/src/pair_sph_rhosum.rst diff --git a/doc/rst/pair_sph_taitwater.rst b/doc/src/pair_sph_taitwater.rst similarity index 100% rename from doc/rst/pair_sph_taitwater.rst rename to doc/src/pair_sph_taitwater.rst diff --git a/doc/rst/pair_sph_taitwater_morris.rst b/doc/src/pair_sph_taitwater_morris.rst similarity index 100% rename from doc/rst/pair_sph_taitwater_morris.rst rename to doc/src/pair_sph_taitwater_morris.rst diff --git a/doc/rst/pair_spin_dipole.rst b/doc/src/pair_spin_dipole.rst similarity index 100% rename from doc/rst/pair_spin_dipole.rst rename to doc/src/pair_spin_dipole.rst diff --git a/doc/rst/pair_spin_dmi.rst b/doc/src/pair_spin_dmi.rst similarity index 100% rename from doc/rst/pair_spin_dmi.rst rename to doc/src/pair_spin_dmi.rst diff --git a/doc/rst/pair_spin_exchange.rst b/doc/src/pair_spin_exchange.rst similarity index 100% rename from doc/rst/pair_spin_exchange.rst rename to doc/src/pair_spin_exchange.rst diff --git a/doc/rst/pair_spin_magelec.rst b/doc/src/pair_spin_magelec.rst similarity index 100% rename from doc/rst/pair_spin_magelec.rst rename to doc/src/pair_spin_magelec.rst diff --git a/doc/rst/pair_spin_neel.rst b/doc/src/pair_spin_neel.rst similarity index 100% rename from doc/rst/pair_spin_neel.rst rename to doc/src/pair_spin_neel.rst diff --git a/doc/rst/pair_srp.rst b/doc/src/pair_srp.rst similarity index 100% rename from doc/rst/pair_srp.rst rename to doc/src/pair_srp.rst diff --git a/doc/rst/pair_style.rst b/doc/src/pair_style.rst similarity index 100% rename from doc/rst/pair_style.rst rename to doc/src/pair_style.rst diff --git a/doc/rst/pair_sw.rst b/doc/src/pair_sw.rst similarity index 100% rename from doc/rst/pair_sw.rst rename to doc/src/pair_sw.rst diff --git a/doc/rst/pair_table.rst b/doc/src/pair_table.rst similarity index 100% rename from doc/rst/pair_table.rst rename to doc/src/pair_table.rst diff --git a/doc/rst/pair_table_rx.rst b/doc/src/pair_table_rx.rst similarity index 100% rename from doc/rst/pair_table_rx.rst rename to doc/src/pair_table_rx.rst diff --git a/doc/rst/pair_tersoff.rst b/doc/src/pair_tersoff.rst similarity index 100% rename from doc/rst/pair_tersoff.rst rename to doc/src/pair_tersoff.rst diff --git a/doc/rst/pair_tersoff_mod.rst b/doc/src/pair_tersoff_mod.rst similarity index 100% rename from doc/rst/pair_tersoff_mod.rst rename to doc/src/pair_tersoff_mod.rst diff --git a/doc/rst/pair_tersoff_zbl.rst b/doc/src/pair_tersoff_zbl.rst similarity index 100% rename from doc/rst/pair_tersoff_zbl.rst rename to doc/src/pair_tersoff_zbl.rst diff --git a/doc/rst/pair_thole.rst b/doc/src/pair_thole.rst similarity index 100% rename from doc/rst/pair_thole.rst rename to doc/src/pair_thole.rst diff --git a/doc/rst/pair_tri_lj.rst b/doc/src/pair_tri_lj.rst similarity index 100% rename from doc/rst/pair_tri_lj.rst rename to doc/src/pair_tri_lj.rst diff --git a/doc/rst/pair_ufm.rst b/doc/src/pair_ufm.rst similarity index 100% rename from doc/rst/pair_ufm.rst rename to doc/src/pair_ufm.rst diff --git a/doc/rst/pair_vashishta.rst b/doc/src/pair_vashishta.rst similarity index 100% rename from doc/rst/pair_vashishta.rst rename to doc/src/pair_vashishta.rst diff --git a/doc/rst/pair_write.rst b/doc/src/pair_write.rst similarity index 100% rename from doc/rst/pair_write.rst rename to doc/src/pair_write.rst diff --git a/doc/rst/pair_yukawa.rst b/doc/src/pair_yukawa.rst similarity index 100% rename from doc/rst/pair_yukawa.rst rename to doc/src/pair_yukawa.rst diff --git a/doc/rst/pair_yukawa_colloid.rst b/doc/src/pair_yukawa_colloid.rst similarity index 100% rename from doc/rst/pair_yukawa_colloid.rst rename to doc/src/pair_yukawa_colloid.rst diff --git a/doc/rst/pair_zbl.rst b/doc/src/pair_zbl.rst similarity index 100% rename from doc/rst/pair_zbl.rst rename to doc/src/pair_zbl.rst diff --git a/doc/rst/pair_zero.rst b/doc/src/pair_zero.rst similarity index 100% rename from doc/rst/pair_zero.rst rename to doc/src/pair_zero.rst diff --git a/doc/rst/pairs.rst b/doc/src/pairs.rst similarity index 100% rename from doc/rst/pairs.rst rename to doc/src/pairs.rst diff --git a/doc/rst/partition.rst b/doc/src/partition.rst similarity index 100% rename from doc/rst/partition.rst rename to doc/src/partition.rst diff --git a/doc/rst/prd.rst b/doc/src/prd.rst similarity index 100% rename from doc/rst/prd.rst rename to doc/src/prd.rst diff --git a/doc/rst/print.rst b/doc/src/print.rst similarity index 100% rename from doc/rst/print.rst rename to doc/src/print.rst diff --git a/doc/rst/processors.rst b/doc/src/processors.rst similarity index 100% rename from doc/rst/processors.rst rename to doc/src/processors.rst diff --git a/doc/rst/python.rst b/doc/src/python.rst similarity index 100% rename from doc/rst/python.rst rename to doc/src/python.rst diff --git a/doc/rst/quit.rst b/doc/src/quit.rst similarity index 100% rename from doc/rst/quit.rst rename to doc/src/quit.rst diff --git a/doc/rst/read_data.rst b/doc/src/read_data.rst similarity index 100% rename from doc/rst/read_data.rst rename to doc/src/read_data.rst diff --git a/doc/rst/read_dump.rst b/doc/src/read_dump.rst similarity index 100% rename from doc/rst/read_dump.rst rename to doc/src/read_dump.rst diff --git a/doc/rst/read_restart.rst b/doc/src/read_restart.rst similarity index 100% rename from doc/rst/read_restart.rst rename to doc/src/read_restart.rst diff --git a/doc/rst/region.rst b/doc/src/region.rst similarity index 100% rename from doc/rst/region.rst rename to doc/src/region.rst diff --git a/doc/rst/replicate.rst b/doc/src/replicate.rst similarity index 100% rename from doc/rst/replicate.rst rename to doc/src/replicate.rst diff --git a/doc/rst/rerun.rst b/doc/src/rerun.rst similarity index 100% rename from doc/rst/rerun.rst rename to doc/src/rerun.rst diff --git a/doc/rst/reset_ids.rst b/doc/src/reset_ids.rst similarity index 100% rename from doc/rst/reset_ids.rst rename to doc/src/reset_ids.rst diff --git a/doc/rst/reset_timestep.rst b/doc/src/reset_timestep.rst similarity index 100% rename from doc/rst/reset_timestep.rst rename to doc/src/reset_timestep.rst diff --git a/doc/rst/restart.rst b/doc/src/restart.rst similarity index 100% rename from doc/rst/restart.rst rename to doc/src/restart.rst diff --git a/doc/rst/run.rst b/doc/src/run.rst similarity index 100% rename from doc/rst/run.rst rename to doc/src/run.rst diff --git a/doc/rst/run_style.rst b/doc/src/run_style.rst similarity index 100% rename from doc/rst/run_style.rst rename to doc/src/run_style.rst diff --git a/doc/rst/server.rst b/doc/src/server.rst similarity index 100% rename from doc/rst/server.rst rename to doc/src/server.rst diff --git a/doc/rst/server_mc.rst b/doc/src/server_mc.rst similarity index 100% rename from doc/rst/server_mc.rst rename to doc/src/server_mc.rst diff --git a/doc/rst/server_md.rst b/doc/src/server_md.rst similarity index 100% rename from doc/rst/server_md.rst rename to doc/src/server_md.rst diff --git a/doc/rst/set.rst b/doc/src/set.rst similarity index 100% rename from doc/rst/set.rst rename to doc/src/set.rst diff --git a/doc/rst/shell.rst b/doc/src/shell.rst similarity index 100% rename from doc/rst/shell.rst rename to doc/src/shell.rst diff --git a/doc/rst/special_bonds.rst b/doc/src/special_bonds.rst similarity index 100% rename from doc/rst/special_bonds.rst rename to doc/src/special_bonds.rst diff --git a/doc/rst/suffix.rst b/doc/src/suffix.rst similarity index 100% rename from doc/rst/suffix.rst rename to doc/src/suffix.rst diff --git a/doc/rst/tad.rst b/doc/src/tad.rst similarity index 100% rename from doc/rst/tad.rst rename to doc/src/tad.rst diff --git a/doc/rst/temper.rst b/doc/src/temper.rst similarity index 100% rename from doc/rst/temper.rst rename to doc/src/temper.rst diff --git a/doc/rst/temper_grem.rst b/doc/src/temper_grem.rst similarity index 100% rename from doc/rst/temper_grem.rst rename to doc/src/temper_grem.rst diff --git a/doc/rst/temper_npt.rst b/doc/src/temper_npt.rst similarity index 100% rename from doc/rst/temper_npt.rst rename to doc/src/temper_npt.rst diff --git a/doc/rst/thermo.rst b/doc/src/thermo.rst similarity index 100% rename from doc/rst/thermo.rst rename to doc/src/thermo.rst diff --git a/doc/rst/thermo_modify.rst b/doc/src/thermo_modify.rst similarity index 100% rename from doc/rst/thermo_modify.rst rename to doc/src/thermo_modify.rst diff --git a/doc/rst/thermo_style.rst b/doc/src/thermo_style.rst similarity index 100% rename from doc/rst/thermo_style.rst rename to doc/src/thermo_style.rst diff --git a/doc/rst/third_order.rst b/doc/src/third_order.rst similarity index 100% rename from doc/rst/third_order.rst rename to doc/src/third_order.rst diff --git a/doc/rst/timer.rst b/doc/src/timer.rst similarity index 100% rename from doc/rst/timer.rst rename to doc/src/timer.rst diff --git a/doc/rst/timestep.rst b/doc/src/timestep.rst similarity index 100% rename from doc/rst/timestep.rst rename to doc/src/timestep.rst diff --git a/doc/rst/uncompute.rst b/doc/src/uncompute.rst similarity index 100% rename from doc/rst/uncompute.rst rename to doc/src/uncompute.rst diff --git a/doc/rst/undump.rst b/doc/src/undump.rst similarity index 100% rename from doc/rst/undump.rst rename to doc/src/undump.rst diff --git a/doc/rst/unfix.rst b/doc/src/unfix.rst similarity index 100% rename from doc/rst/unfix.rst rename to doc/src/unfix.rst diff --git a/doc/rst/units.rst b/doc/src/units.rst similarity index 100% rename from doc/rst/units.rst rename to doc/src/units.rst diff --git a/doc/rst/variable.rst b/doc/src/variable.rst similarity index 100% rename from doc/rst/variable.rst rename to doc/src/variable.rst diff --git a/doc/rst/velocity.rst b/doc/src/velocity.rst similarity index 100% rename from doc/rst/velocity.rst rename to doc/src/velocity.rst diff --git a/doc/rst/write_coeff.rst b/doc/src/write_coeff.rst similarity index 100% rename from doc/rst/write_coeff.rst rename to doc/src/write_coeff.rst diff --git a/doc/rst/write_data.rst b/doc/src/write_data.rst similarity index 100% rename from doc/rst/write_data.rst rename to doc/src/write_data.rst diff --git a/doc/rst/write_dump.rst b/doc/src/write_dump.rst similarity index 100% rename from doc/rst/write_dump.rst rename to doc/src/write_dump.rst diff --git a/doc/rst/write_restart.rst b/doc/src/write_restart.rst similarity index 100% rename from doc/rst/write_restart.rst rename to doc/src/write_restart.rst diff --git a/doc/src/Build.txt b/doc/txt/Build.txt similarity index 100% rename from doc/src/Build.txt rename to doc/txt/Build.txt diff --git a/doc/src/Build_basics.txt b/doc/txt/Build_basics.txt similarity index 100% rename from doc/src/Build_basics.txt rename to doc/txt/Build_basics.txt diff --git a/doc/src/Build_cmake.txt b/doc/txt/Build_cmake.txt similarity index 100% rename from doc/src/Build_cmake.txt rename to doc/txt/Build_cmake.txt diff --git a/doc/src/Build_development.txt b/doc/txt/Build_development.txt similarity index 100% rename from doc/src/Build_development.txt rename to doc/txt/Build_development.txt diff --git a/doc/src/Build_extras.txt b/doc/txt/Build_extras.txt similarity index 100% rename from doc/src/Build_extras.txt rename to doc/txt/Build_extras.txt diff --git a/doc/src/Build_link.txt b/doc/txt/Build_link.txt similarity index 100% rename from doc/src/Build_link.txt rename to doc/txt/Build_link.txt diff --git a/doc/src/Build_make.txt b/doc/txt/Build_make.txt similarity index 100% rename from doc/src/Build_make.txt rename to doc/txt/Build_make.txt diff --git a/doc/src/Build_package.txt b/doc/txt/Build_package.txt similarity index 100% rename from doc/src/Build_package.txt rename to doc/txt/Build_package.txt diff --git a/doc/src/Build_settings.txt b/doc/txt/Build_settings.txt similarity index 100% rename from doc/src/Build_settings.txt rename to doc/txt/Build_settings.txt diff --git a/doc/src/Build_windows.txt b/doc/txt/Build_windows.txt similarity index 100% rename from doc/src/Build_windows.txt rename to doc/txt/Build_windows.txt diff --git a/doc/src/Commands.txt b/doc/txt/Commands.txt similarity index 100% rename from doc/src/Commands.txt rename to doc/txt/Commands.txt diff --git a/doc/src/Commands_all.txt b/doc/txt/Commands_all.txt similarity index 100% rename from doc/src/Commands_all.txt rename to doc/txt/Commands_all.txt diff --git a/doc/src/Commands_bond.txt b/doc/txt/Commands_bond.txt similarity index 100% rename from doc/src/Commands_bond.txt rename to doc/txt/Commands_bond.txt diff --git a/doc/src/Commands_category.txt b/doc/txt/Commands_category.txt similarity index 100% rename from doc/src/Commands_category.txt rename to doc/txt/Commands_category.txt diff --git a/doc/src/Commands_compute.txt b/doc/txt/Commands_compute.txt similarity index 100% rename from doc/src/Commands_compute.txt rename to doc/txt/Commands_compute.txt diff --git a/doc/src/Commands_fix.txt b/doc/txt/Commands_fix.txt similarity index 100% rename from doc/src/Commands_fix.txt rename to doc/txt/Commands_fix.txt diff --git a/doc/src/Commands_input.txt b/doc/txt/Commands_input.txt similarity index 100% rename from doc/src/Commands_input.txt rename to doc/txt/Commands_input.txt diff --git a/doc/src/Commands_kspace.txt b/doc/txt/Commands_kspace.txt similarity index 100% rename from doc/src/Commands_kspace.txt rename to doc/txt/Commands_kspace.txt diff --git a/doc/src/Commands_pair.txt b/doc/txt/Commands_pair.txt similarity index 100% rename from doc/src/Commands_pair.txt rename to doc/txt/Commands_pair.txt diff --git a/doc/src/Commands_parse.txt b/doc/txt/Commands_parse.txt similarity index 100% rename from doc/src/Commands_parse.txt rename to doc/txt/Commands_parse.txt diff --git a/doc/src/Commands_removed.txt b/doc/txt/Commands_removed.txt similarity index 100% rename from doc/src/Commands_removed.txt rename to doc/txt/Commands_removed.txt diff --git a/doc/src/Commands_structure.txt b/doc/txt/Commands_structure.txt similarity index 100% rename from doc/src/Commands_structure.txt rename to doc/txt/Commands_structure.txt diff --git a/doc/src/Developer/.gitignore b/doc/txt/Developer/.gitignore similarity index 100% rename from doc/src/Developer/.gitignore rename to doc/txt/Developer/.gitignore diff --git a/doc/src/Developer/classes.fig b/doc/txt/Developer/classes.fig similarity index 100% rename from doc/src/Developer/classes.fig rename to doc/txt/Developer/classes.fig diff --git a/doc/src/Developer/classes.pdf b/doc/txt/Developer/classes.pdf similarity index 100% rename from doc/src/Developer/classes.pdf rename to doc/txt/Developer/classes.pdf diff --git a/doc/src/Developer/developer.tex b/doc/txt/Developer/developer.tex similarity index 100% rename from doc/src/Developer/developer.tex rename to doc/txt/Developer/developer.tex diff --git a/doc/src/Errors.txt b/doc/txt/Errors.txt similarity index 100% rename from doc/src/Errors.txt rename to doc/txt/Errors.txt diff --git a/doc/src/Errors_bugs.txt b/doc/txt/Errors_bugs.txt similarity index 100% rename from doc/src/Errors_bugs.txt rename to doc/txt/Errors_bugs.txt diff --git a/doc/src/Errors_common.txt b/doc/txt/Errors_common.txt similarity index 100% rename from doc/src/Errors_common.txt rename to doc/txt/Errors_common.txt diff --git a/doc/src/Errors_messages.txt b/doc/txt/Errors_messages.txt similarity index 100% rename from doc/src/Errors_messages.txt rename to doc/txt/Errors_messages.txt diff --git a/doc/src/Errors_warnings.txt b/doc/txt/Errors_warnings.txt similarity index 100% rename from doc/src/Errors_warnings.txt rename to doc/txt/Errors_warnings.txt diff --git a/doc/src/Examples.txt b/doc/txt/Examples.txt similarity index 100% rename from doc/src/Examples.txt rename to doc/txt/Examples.txt diff --git a/doc/src/Howto.txt b/doc/txt/Howto.txt similarity index 100% rename from doc/src/Howto.txt rename to doc/txt/Howto.txt diff --git a/doc/src/Howto_2d.txt b/doc/txt/Howto_2d.txt similarity index 100% rename from doc/src/Howto_2d.txt rename to doc/txt/Howto_2d.txt diff --git a/doc/src/Howto_barostat.txt b/doc/txt/Howto_barostat.txt similarity index 100% rename from doc/src/Howto_barostat.txt rename to doc/txt/Howto_barostat.txt diff --git a/doc/src/Howto_bash.txt b/doc/txt/Howto_bash.txt similarity index 100% rename from doc/src/Howto_bash.txt rename to doc/txt/Howto_bash.txt diff --git a/doc/src/Howto_bioFF.txt b/doc/txt/Howto_bioFF.txt similarity index 100% rename from doc/src/Howto_bioFF.txt rename to doc/txt/Howto_bioFF.txt diff --git a/doc/src/Howto_body.txt b/doc/txt/Howto_body.txt similarity index 100% rename from doc/src/Howto_body.txt rename to doc/txt/Howto_body.txt diff --git a/doc/src/Howto_chunk.txt b/doc/txt/Howto_chunk.txt similarity index 100% rename from doc/src/Howto_chunk.txt rename to doc/txt/Howto_chunk.txt diff --git a/doc/src/Howto_client_server.txt b/doc/txt/Howto_client_server.txt similarity index 100% rename from doc/src/Howto_client_server.txt rename to doc/txt/Howto_client_server.txt diff --git a/doc/src/Howto_coreshell.txt b/doc/txt/Howto_coreshell.txt similarity index 100% rename from doc/src/Howto_coreshell.txt rename to doc/txt/Howto_coreshell.txt diff --git a/doc/src/Howto_couple.txt b/doc/txt/Howto_couple.txt similarity index 100% rename from doc/src/Howto_couple.txt rename to doc/txt/Howto_couple.txt diff --git a/doc/src/Howto_diffusion.txt b/doc/txt/Howto_diffusion.txt similarity index 100% rename from doc/src/Howto_diffusion.txt rename to doc/txt/Howto_diffusion.txt diff --git a/doc/src/Howto_dispersion.txt b/doc/txt/Howto_dispersion.txt similarity index 100% rename from doc/src/Howto_dispersion.txt rename to doc/txt/Howto_dispersion.txt diff --git a/doc/src/Howto_drude.txt b/doc/txt/Howto_drude.txt similarity index 100% rename from doc/src/Howto_drude.txt rename to doc/txt/Howto_drude.txt diff --git a/doc/src/Howto_drude2.txt b/doc/txt/Howto_drude2.txt similarity index 100% rename from doc/src/Howto_drude2.txt rename to doc/txt/Howto_drude2.txt diff --git a/doc/src/Howto_elastic.txt b/doc/txt/Howto_elastic.txt similarity index 100% rename from doc/src/Howto_elastic.txt rename to doc/txt/Howto_elastic.txt diff --git a/doc/src/Howto_github.txt b/doc/txt/Howto_github.txt similarity index 100% rename from doc/src/Howto_github.txt rename to doc/txt/Howto_github.txt diff --git a/doc/src/Howto_granular.txt b/doc/txt/Howto_granular.txt similarity index 100% rename from doc/src/Howto_granular.txt rename to doc/txt/Howto_granular.txt diff --git a/doc/src/Howto_kappa.txt b/doc/txt/Howto_kappa.txt similarity index 100% rename from doc/src/Howto_kappa.txt rename to doc/txt/Howto_kappa.txt diff --git a/doc/src/Howto_library.txt b/doc/txt/Howto_library.txt similarity index 100% rename from doc/src/Howto_library.txt rename to doc/txt/Howto_library.txt diff --git a/doc/src/Howto_manifold.txt b/doc/txt/Howto_manifold.txt similarity index 100% rename from doc/src/Howto_manifold.txt rename to doc/txt/Howto_manifold.txt diff --git a/doc/src/Howto_multiple.txt b/doc/txt/Howto_multiple.txt similarity index 100% rename from doc/src/Howto_multiple.txt rename to doc/txt/Howto_multiple.txt diff --git a/doc/src/Howto_nemd.txt b/doc/txt/Howto_nemd.txt similarity index 100% rename from doc/src/Howto_nemd.txt rename to doc/txt/Howto_nemd.txt diff --git a/doc/src/Howto_output.txt b/doc/txt/Howto_output.txt similarity index 100% rename from doc/src/Howto_output.txt rename to doc/txt/Howto_output.txt diff --git a/doc/src/Howto_polarizable.txt b/doc/txt/Howto_polarizable.txt similarity index 100% rename from doc/src/Howto_polarizable.txt rename to doc/txt/Howto_polarizable.txt diff --git a/doc/src/Howto_pylammps.txt b/doc/txt/Howto_pylammps.txt similarity index 100% rename from doc/src/Howto_pylammps.txt rename to doc/txt/Howto_pylammps.txt diff --git a/doc/src/Howto_replica.txt b/doc/txt/Howto_replica.txt similarity index 100% rename from doc/src/Howto_replica.txt rename to doc/txt/Howto_replica.txt diff --git a/doc/src/Howto_restart.txt b/doc/txt/Howto_restart.txt similarity index 100% rename from doc/src/Howto_restart.txt rename to doc/txt/Howto_restart.txt diff --git a/doc/src/Howto_spc.txt b/doc/txt/Howto_spc.txt similarity index 100% rename from doc/src/Howto_spc.txt rename to doc/txt/Howto_spc.txt diff --git a/doc/src/Howto_spherical.txt b/doc/txt/Howto_spherical.txt similarity index 100% rename from doc/src/Howto_spherical.txt rename to doc/txt/Howto_spherical.txt diff --git a/doc/src/Howto_spins.txt b/doc/txt/Howto_spins.txt similarity index 100% rename from doc/src/Howto_spins.txt rename to doc/txt/Howto_spins.txt diff --git a/doc/src/Howto_temperature.txt b/doc/txt/Howto_temperature.txt similarity index 100% rename from doc/src/Howto_temperature.txt rename to doc/txt/Howto_temperature.txt diff --git a/doc/src/Howto_thermostat.txt b/doc/txt/Howto_thermostat.txt similarity index 100% rename from doc/src/Howto_thermostat.txt rename to doc/txt/Howto_thermostat.txt diff --git a/doc/src/Howto_tip3p.txt b/doc/txt/Howto_tip3p.txt similarity index 100% rename from doc/src/Howto_tip3p.txt rename to doc/txt/Howto_tip3p.txt diff --git a/doc/src/Howto_tip4p.txt b/doc/txt/Howto_tip4p.txt similarity index 100% rename from doc/src/Howto_tip4p.txt rename to doc/txt/Howto_tip4p.txt diff --git a/doc/src/Howto_triclinic.txt b/doc/txt/Howto_triclinic.txt similarity index 100% rename from doc/src/Howto_triclinic.txt rename to doc/txt/Howto_triclinic.txt diff --git a/doc/src/Howto_viscosity.txt b/doc/txt/Howto_viscosity.txt similarity index 100% rename from doc/src/Howto_viscosity.txt rename to doc/txt/Howto_viscosity.txt diff --git a/doc/src/Howto_viz.txt b/doc/txt/Howto_viz.txt similarity index 100% rename from doc/src/Howto_viz.txt rename to doc/txt/Howto_viz.txt diff --git a/doc/src/Howto_walls.txt b/doc/txt/Howto_walls.txt similarity index 100% rename from doc/src/Howto_walls.txt rename to doc/txt/Howto_walls.txt diff --git a/doc/src/Install.txt b/doc/txt/Install.txt similarity index 100% rename from doc/src/Install.txt rename to doc/txt/Install.txt diff --git a/doc/src/Install_git.txt b/doc/txt/Install_git.txt similarity index 100% rename from doc/src/Install_git.txt rename to doc/txt/Install_git.txt diff --git a/doc/src/Install_linux.txt b/doc/txt/Install_linux.txt similarity index 100% rename from doc/src/Install_linux.txt rename to doc/txt/Install_linux.txt diff --git a/doc/src/Install_mac.txt b/doc/txt/Install_mac.txt similarity index 100% rename from doc/src/Install_mac.txt rename to doc/txt/Install_mac.txt diff --git a/doc/src/Install_patch.txt b/doc/txt/Install_patch.txt similarity index 100% rename from doc/src/Install_patch.txt rename to doc/txt/Install_patch.txt diff --git a/doc/src/Install_svn.txt b/doc/txt/Install_svn.txt similarity index 100% rename from doc/src/Install_svn.txt rename to doc/txt/Install_svn.txt diff --git a/doc/src/Install_tarball.txt b/doc/txt/Install_tarball.txt similarity index 100% rename from doc/src/Install_tarball.txt rename to doc/txt/Install_tarball.txt diff --git a/doc/src/Install_windows.txt b/doc/txt/Install_windows.txt similarity index 100% rename from doc/src/Install_windows.txt rename to doc/txt/Install_windows.txt diff --git a/doc/src/Intro.txt b/doc/txt/Intro.txt similarity index 100% rename from doc/src/Intro.txt rename to doc/txt/Intro.txt diff --git a/doc/src/Intro_authors.txt b/doc/txt/Intro_authors.txt similarity index 100% rename from doc/src/Intro_authors.txt rename to doc/txt/Intro_authors.txt diff --git a/doc/src/Intro_features.txt b/doc/txt/Intro_features.txt similarity index 100% rename from doc/src/Intro_features.txt rename to doc/txt/Intro_features.txt diff --git a/doc/src/Intro_nonfeatures.txt b/doc/txt/Intro_nonfeatures.txt similarity index 100% rename from doc/src/Intro_nonfeatures.txt rename to doc/txt/Intro_nonfeatures.txt diff --git a/doc/src/Intro_opensource.txt b/doc/txt/Intro_opensource.txt similarity index 100% rename from doc/src/Intro_opensource.txt rename to doc/txt/Intro_opensource.txt diff --git a/doc/src/Intro_overview.txt b/doc/txt/Intro_overview.txt similarity index 100% rename from doc/src/Intro_overview.txt rename to doc/txt/Intro_overview.txt diff --git a/doc/src/Intro_website.txt b/doc/txt/Intro_website.txt similarity index 100% rename from doc/src/Intro_website.txt rename to doc/txt/Intro_website.txt diff --git a/doc/src/Manual.txt b/doc/txt/Manual.txt similarity index 100% rename from doc/src/Manual.txt rename to doc/txt/Manual.txt diff --git a/doc/src/Manual_build.txt b/doc/txt/Manual_build.txt similarity index 100% rename from doc/src/Manual_build.txt rename to doc/txt/Manual_build.txt diff --git a/doc/src/Manual_version.txt b/doc/txt/Manual_version.txt similarity index 100% rename from doc/src/Manual_version.txt rename to doc/txt/Manual_version.txt diff --git a/doc/src/Modify.txt b/doc/txt/Modify.txt similarity index 100% rename from doc/src/Modify.txt rename to doc/txt/Modify.txt diff --git a/doc/src/Modify_atom.txt b/doc/txt/Modify_atom.txt similarity index 100% rename from doc/src/Modify_atom.txt rename to doc/txt/Modify_atom.txt diff --git a/doc/src/Modify_body.txt b/doc/txt/Modify_body.txt similarity index 100% rename from doc/src/Modify_body.txt rename to doc/txt/Modify_body.txt diff --git a/doc/src/Modify_bond.txt b/doc/txt/Modify_bond.txt similarity index 100% rename from doc/src/Modify_bond.txt rename to doc/txt/Modify_bond.txt diff --git a/doc/src/Modify_command.txt b/doc/txt/Modify_command.txt similarity index 100% rename from doc/src/Modify_command.txt rename to doc/txt/Modify_command.txt diff --git a/doc/src/Modify_compute.txt b/doc/txt/Modify_compute.txt similarity index 100% rename from doc/src/Modify_compute.txt rename to doc/txt/Modify_compute.txt diff --git a/doc/src/Modify_contribute.txt b/doc/txt/Modify_contribute.txt similarity index 100% rename from doc/src/Modify_contribute.txt rename to doc/txt/Modify_contribute.txt diff --git a/doc/src/Modify_dump.txt b/doc/txt/Modify_dump.txt similarity index 100% rename from doc/src/Modify_dump.txt rename to doc/txt/Modify_dump.txt diff --git a/doc/src/Modify_fix.txt b/doc/txt/Modify_fix.txt similarity index 100% rename from doc/src/Modify_fix.txt rename to doc/txt/Modify_fix.txt diff --git a/doc/src/Modify_kspace.txt b/doc/txt/Modify_kspace.txt similarity index 100% rename from doc/src/Modify_kspace.txt rename to doc/txt/Modify_kspace.txt diff --git a/doc/src/Modify_min.txt b/doc/txt/Modify_min.txt similarity index 100% rename from doc/src/Modify_min.txt rename to doc/txt/Modify_min.txt diff --git a/doc/src/Modify_overview.txt b/doc/txt/Modify_overview.txt similarity index 100% rename from doc/src/Modify_overview.txt rename to doc/txt/Modify_overview.txt diff --git a/doc/src/Modify_pair.txt b/doc/txt/Modify_pair.txt similarity index 100% rename from doc/src/Modify_pair.txt rename to doc/txt/Modify_pair.txt diff --git a/doc/src/Modify_region.txt b/doc/txt/Modify_region.txt similarity index 100% rename from doc/src/Modify_region.txt rename to doc/txt/Modify_region.txt diff --git a/doc/src/Modify_thermo.txt b/doc/txt/Modify_thermo.txt similarity index 100% rename from doc/src/Modify_thermo.txt rename to doc/txt/Modify_thermo.txt diff --git a/doc/src/Modify_variable.txt b/doc/txt/Modify_variable.txt similarity index 100% rename from doc/src/Modify_variable.txt rename to doc/txt/Modify_variable.txt diff --git a/doc/src/Packages.txt b/doc/txt/Packages.txt similarity index 100% rename from doc/src/Packages.txt rename to doc/txt/Packages.txt diff --git a/doc/src/Packages_details.txt b/doc/txt/Packages_details.txt similarity index 100% rename from doc/src/Packages_details.txt rename to doc/txt/Packages_details.txt diff --git a/doc/src/Packages_standard.txt b/doc/txt/Packages_standard.txt similarity index 100% rename from doc/src/Packages_standard.txt rename to doc/txt/Packages_standard.txt diff --git a/doc/src/Packages_user.txt b/doc/txt/Packages_user.txt similarity index 100% rename from doc/src/Packages_user.txt rename to doc/txt/Packages_user.txt diff --git a/doc/src/Python_call.txt b/doc/txt/Python_call.txt similarity index 100% rename from doc/src/Python_call.txt rename to doc/txt/Python_call.txt diff --git a/doc/src/Python_examples.txt b/doc/txt/Python_examples.txt similarity index 100% rename from doc/src/Python_examples.txt rename to doc/txt/Python_examples.txt diff --git a/doc/src/Python_head.txt b/doc/txt/Python_head.txt similarity index 100% rename from doc/src/Python_head.txt rename to doc/txt/Python_head.txt diff --git a/doc/src/Python_install.txt b/doc/txt/Python_install.txt similarity index 100% rename from doc/src/Python_install.txt rename to doc/txt/Python_install.txt diff --git a/doc/src/Python_library.txt b/doc/txt/Python_library.txt similarity index 100% rename from doc/src/Python_library.txt rename to doc/txt/Python_library.txt diff --git a/doc/src/Python_mpi.txt b/doc/txt/Python_mpi.txt similarity index 100% rename from doc/src/Python_mpi.txt rename to doc/txt/Python_mpi.txt diff --git a/doc/src/Python_overview.txt b/doc/txt/Python_overview.txt similarity index 100% rename from doc/src/Python_overview.txt rename to doc/txt/Python_overview.txt diff --git a/doc/src/Python_pylammps.txt b/doc/txt/Python_pylammps.txt similarity index 100% rename from doc/src/Python_pylammps.txt rename to doc/txt/Python_pylammps.txt diff --git a/doc/src/Python_run.txt b/doc/txt/Python_run.txt similarity index 100% rename from doc/src/Python_run.txt rename to doc/txt/Python_run.txt diff --git a/doc/src/Python_shlib.txt b/doc/txt/Python_shlib.txt similarity index 100% rename from doc/src/Python_shlib.txt rename to doc/txt/Python_shlib.txt diff --git a/doc/src/Python_test.txt b/doc/txt/Python_test.txt similarity index 100% rename from doc/src/Python_test.txt rename to doc/txt/Python_test.txt diff --git a/doc/src/Run_basics.txt b/doc/txt/Run_basics.txt similarity index 100% rename from doc/src/Run_basics.txt rename to doc/txt/Run_basics.txt diff --git a/doc/src/Run_head.txt b/doc/txt/Run_head.txt similarity index 100% rename from doc/src/Run_head.txt rename to doc/txt/Run_head.txt diff --git a/doc/src/Run_options.txt b/doc/txt/Run_options.txt similarity index 100% rename from doc/src/Run_options.txt rename to doc/txt/Run_options.txt diff --git a/doc/src/Run_output.txt b/doc/txt/Run_output.txt similarity index 100% rename from doc/src/Run_output.txt rename to doc/txt/Run_output.txt diff --git a/doc/src/Run_windows.txt b/doc/txt/Run_windows.txt similarity index 100% rename from doc/src/Run_windows.txt rename to doc/txt/Run_windows.txt diff --git a/doc/src/Speed.txt b/doc/txt/Speed.txt similarity index 100% rename from doc/src/Speed.txt rename to doc/txt/Speed.txt diff --git a/doc/src/Speed_bench.txt b/doc/txt/Speed_bench.txt similarity index 100% rename from doc/src/Speed_bench.txt rename to doc/txt/Speed_bench.txt diff --git a/doc/src/Speed_compare.txt b/doc/txt/Speed_compare.txt similarity index 100% rename from doc/src/Speed_compare.txt rename to doc/txt/Speed_compare.txt diff --git a/doc/src/Speed_gpu.txt b/doc/txt/Speed_gpu.txt similarity index 100% rename from doc/src/Speed_gpu.txt rename to doc/txt/Speed_gpu.txt diff --git a/doc/src/Speed_intel.txt b/doc/txt/Speed_intel.txt similarity index 100% rename from doc/src/Speed_intel.txt rename to doc/txt/Speed_intel.txt diff --git a/doc/src/Speed_kokkos.txt b/doc/txt/Speed_kokkos.txt similarity index 100% rename from doc/src/Speed_kokkos.txt rename to doc/txt/Speed_kokkos.txt diff --git a/doc/src/Speed_measure.txt b/doc/txt/Speed_measure.txt similarity index 100% rename from doc/src/Speed_measure.txt rename to doc/txt/Speed_measure.txt diff --git a/doc/src/Speed_omp.txt b/doc/txt/Speed_omp.txt similarity index 100% rename from doc/src/Speed_omp.txt rename to doc/txt/Speed_omp.txt diff --git a/doc/src/Speed_opt.txt b/doc/txt/Speed_opt.txt similarity index 100% rename from doc/src/Speed_opt.txt rename to doc/txt/Speed_opt.txt diff --git a/doc/src/Speed_packages.txt b/doc/txt/Speed_packages.txt similarity index 100% rename from doc/src/Speed_packages.txt rename to doc/txt/Speed_packages.txt diff --git a/doc/src/Speed_tips.txt b/doc/txt/Speed_tips.txt similarity index 100% rename from doc/src/Speed_tips.txt rename to doc/txt/Speed_tips.txt diff --git a/doc/src/Tools.txt b/doc/txt/Tools.txt similarity index 100% rename from doc/src/Tools.txt rename to doc/txt/Tools.txt diff --git a/doc/src/angle_charmm.txt b/doc/txt/angle_charmm.txt similarity index 100% rename from doc/src/angle_charmm.txt rename to doc/txt/angle_charmm.txt diff --git a/doc/src/angle_class2.txt b/doc/txt/angle_class2.txt similarity index 100% rename from doc/src/angle_class2.txt rename to doc/txt/angle_class2.txt diff --git a/doc/src/angle_coeff.txt b/doc/txt/angle_coeff.txt similarity index 100% rename from doc/src/angle_coeff.txt rename to doc/txt/angle_coeff.txt diff --git a/doc/src/angle_cosine.txt b/doc/txt/angle_cosine.txt similarity index 100% rename from doc/src/angle_cosine.txt rename to doc/txt/angle_cosine.txt diff --git a/doc/src/angle_cosine_buck6d.txt b/doc/txt/angle_cosine_buck6d.txt similarity index 100% rename from doc/src/angle_cosine_buck6d.txt rename to doc/txt/angle_cosine_buck6d.txt diff --git a/doc/src/angle_cosine_delta.txt b/doc/txt/angle_cosine_delta.txt similarity index 100% rename from doc/src/angle_cosine_delta.txt rename to doc/txt/angle_cosine_delta.txt diff --git a/doc/src/angle_cosine_periodic.txt b/doc/txt/angle_cosine_periodic.txt similarity index 100% rename from doc/src/angle_cosine_periodic.txt rename to doc/txt/angle_cosine_periodic.txt diff --git a/doc/src/angle_cosine_shift.txt b/doc/txt/angle_cosine_shift.txt similarity index 100% rename from doc/src/angle_cosine_shift.txt rename to doc/txt/angle_cosine_shift.txt diff --git a/doc/src/angle_cosine_shift_exp.txt b/doc/txt/angle_cosine_shift_exp.txt similarity index 100% rename from doc/src/angle_cosine_shift_exp.txt rename to doc/txt/angle_cosine_shift_exp.txt diff --git a/doc/src/angle_cosine_squared.txt b/doc/txt/angle_cosine_squared.txt similarity index 100% rename from doc/src/angle_cosine_squared.txt rename to doc/txt/angle_cosine_squared.txt diff --git a/doc/src/angle_cross.txt b/doc/txt/angle_cross.txt similarity index 100% rename from doc/src/angle_cross.txt rename to doc/txt/angle_cross.txt diff --git a/doc/src/angle_dipole.txt b/doc/txt/angle_dipole.txt similarity index 100% rename from doc/src/angle_dipole.txt rename to doc/txt/angle_dipole.txt diff --git a/doc/src/angle_fourier.txt b/doc/txt/angle_fourier.txt similarity index 100% rename from doc/src/angle_fourier.txt rename to doc/txt/angle_fourier.txt diff --git a/doc/src/angle_fourier_simple.txt b/doc/txt/angle_fourier_simple.txt similarity index 100% rename from doc/src/angle_fourier_simple.txt rename to doc/txt/angle_fourier_simple.txt diff --git a/doc/src/angle_harmonic.txt b/doc/txt/angle_harmonic.txt similarity index 100% rename from doc/src/angle_harmonic.txt rename to doc/txt/angle_harmonic.txt diff --git a/doc/src/angle_hybrid.txt b/doc/txt/angle_hybrid.txt similarity index 100% rename from doc/src/angle_hybrid.txt rename to doc/txt/angle_hybrid.txt diff --git a/doc/src/angle_mm3.txt b/doc/txt/angle_mm3.txt similarity index 100% rename from doc/src/angle_mm3.txt rename to doc/txt/angle_mm3.txt diff --git a/doc/src/angle_none.txt b/doc/txt/angle_none.txt similarity index 100% rename from doc/src/angle_none.txt rename to doc/txt/angle_none.txt diff --git a/doc/src/angle_quartic.txt b/doc/txt/angle_quartic.txt similarity index 100% rename from doc/src/angle_quartic.txt rename to doc/txt/angle_quartic.txt diff --git a/doc/src/angle_sdk.txt b/doc/txt/angle_sdk.txt similarity index 100% rename from doc/src/angle_sdk.txt rename to doc/txt/angle_sdk.txt diff --git a/doc/src/angle_style.txt b/doc/txt/angle_style.txt similarity index 100% rename from doc/src/angle_style.txt rename to doc/txt/angle_style.txt diff --git a/doc/src/angle_table.txt b/doc/txt/angle_table.txt similarity index 100% rename from doc/src/angle_table.txt rename to doc/txt/angle_table.txt diff --git a/doc/src/angle_zero.txt b/doc/txt/angle_zero.txt similarity index 100% rename from doc/src/angle_zero.txt rename to doc/txt/angle_zero.txt diff --git a/doc/src/angles.txt b/doc/txt/angles.txt similarity index 100% rename from doc/src/angles.txt rename to doc/txt/angles.txt diff --git a/doc/src/atom_modify.txt b/doc/txt/atom_modify.txt similarity index 100% rename from doc/src/atom_modify.txt rename to doc/txt/atom_modify.txt diff --git a/doc/src/atom_style.txt b/doc/txt/atom_style.txt similarity index 100% rename from doc/src/atom_style.txt rename to doc/txt/atom_style.txt diff --git a/doc/src/balance.txt b/doc/txt/balance.txt similarity index 100% rename from doc/src/balance.txt rename to doc/txt/balance.txt diff --git a/doc/src/bond_class2.txt b/doc/txt/bond_class2.txt similarity index 100% rename from doc/src/bond_class2.txt rename to doc/txt/bond_class2.txt diff --git a/doc/src/bond_coeff.txt b/doc/txt/bond_coeff.txt similarity index 100% rename from doc/src/bond_coeff.txt rename to doc/txt/bond_coeff.txt diff --git a/doc/src/bond_fene.txt b/doc/txt/bond_fene.txt similarity index 100% rename from doc/src/bond_fene.txt rename to doc/txt/bond_fene.txt diff --git a/doc/src/bond_fene_expand.txt b/doc/txt/bond_fene_expand.txt similarity index 100% rename from doc/src/bond_fene_expand.txt rename to doc/txt/bond_fene_expand.txt diff --git a/doc/src/bond_gromos.txt b/doc/txt/bond_gromos.txt similarity index 100% rename from doc/src/bond_gromos.txt rename to doc/txt/bond_gromos.txt diff --git a/doc/src/bond_harmonic.txt b/doc/txt/bond_harmonic.txt similarity index 100% rename from doc/src/bond_harmonic.txt rename to doc/txt/bond_harmonic.txt diff --git a/doc/src/bond_harmonic_shift.txt b/doc/txt/bond_harmonic_shift.txt similarity index 100% rename from doc/src/bond_harmonic_shift.txt rename to doc/txt/bond_harmonic_shift.txt diff --git a/doc/src/bond_harmonic_shift_cut.txt b/doc/txt/bond_harmonic_shift_cut.txt similarity index 100% rename from doc/src/bond_harmonic_shift_cut.txt rename to doc/txt/bond_harmonic_shift_cut.txt diff --git a/doc/src/bond_hybrid.txt b/doc/txt/bond_hybrid.txt similarity index 100% rename from doc/src/bond_hybrid.txt rename to doc/txt/bond_hybrid.txt diff --git a/doc/src/bond_mm3.txt b/doc/txt/bond_mm3.txt similarity index 100% rename from doc/src/bond_mm3.txt rename to doc/txt/bond_mm3.txt diff --git a/doc/src/bond_morse.txt b/doc/txt/bond_morse.txt similarity index 100% rename from doc/src/bond_morse.txt rename to doc/txt/bond_morse.txt diff --git a/doc/src/bond_none.txt b/doc/txt/bond_none.txt similarity index 100% rename from doc/src/bond_none.txt rename to doc/txt/bond_none.txt diff --git a/doc/src/bond_nonlinear.txt b/doc/txt/bond_nonlinear.txt similarity index 100% rename from doc/src/bond_nonlinear.txt rename to doc/txt/bond_nonlinear.txt diff --git a/doc/src/bond_oxdna.txt b/doc/txt/bond_oxdna.txt similarity index 100% rename from doc/src/bond_oxdna.txt rename to doc/txt/bond_oxdna.txt diff --git a/doc/src/bond_quartic.txt b/doc/txt/bond_quartic.txt similarity index 100% rename from doc/src/bond_quartic.txt rename to doc/txt/bond_quartic.txt diff --git a/doc/src/bond_style.txt b/doc/txt/bond_style.txt similarity index 100% rename from doc/src/bond_style.txt rename to doc/txt/bond_style.txt diff --git a/doc/src/bond_table.txt b/doc/txt/bond_table.txt similarity index 100% rename from doc/src/bond_table.txt rename to doc/txt/bond_table.txt diff --git a/doc/src/bond_write.txt b/doc/txt/bond_write.txt similarity index 100% rename from doc/src/bond_write.txt rename to doc/txt/bond_write.txt diff --git a/doc/src/bond_zero.txt b/doc/txt/bond_zero.txt similarity index 100% rename from doc/src/bond_zero.txt rename to doc/txt/bond_zero.txt diff --git a/doc/src/bonds.txt b/doc/txt/bonds.txt similarity index 100% rename from doc/src/bonds.txt rename to doc/txt/bonds.txt diff --git a/doc/src/boundary.txt b/doc/txt/boundary.txt similarity index 100% rename from doc/src/boundary.txt rename to doc/txt/boundary.txt diff --git a/doc/src/box.txt b/doc/txt/box.txt similarity index 100% rename from doc/src/box.txt rename to doc/txt/box.txt diff --git a/doc/src/change_box.txt b/doc/txt/change_box.txt similarity index 100% rename from doc/src/change_box.txt rename to doc/txt/change_box.txt diff --git a/doc/src/clear.txt b/doc/txt/clear.txt similarity index 100% rename from doc/src/clear.txt rename to doc/txt/clear.txt diff --git a/doc/src/comm_modify.txt b/doc/txt/comm_modify.txt similarity index 100% rename from doc/src/comm_modify.txt rename to doc/txt/comm_modify.txt diff --git a/doc/src/comm_style.txt b/doc/txt/comm_style.txt similarity index 100% rename from doc/src/comm_style.txt rename to doc/txt/comm_style.txt diff --git a/doc/src/commands_list.txt b/doc/txt/commands_list.txt similarity index 100% rename from doc/src/commands_list.txt rename to doc/txt/commands_list.txt diff --git a/doc/src/compute.txt b/doc/txt/compute.txt similarity index 100% rename from doc/src/compute.txt rename to doc/txt/compute.txt diff --git a/doc/src/compute_ackland_atom.txt b/doc/txt/compute_ackland_atom.txt similarity index 100% rename from doc/src/compute_ackland_atom.txt rename to doc/txt/compute_ackland_atom.txt diff --git a/doc/src/compute_adf.txt b/doc/txt/compute_adf.txt similarity index 100% rename from doc/src/compute_adf.txt rename to doc/txt/compute_adf.txt diff --git a/doc/src/compute_angle.txt b/doc/txt/compute_angle.txt similarity index 100% rename from doc/src/compute_angle.txt rename to doc/txt/compute_angle.txt diff --git a/doc/src/compute_angle_local.txt b/doc/txt/compute_angle_local.txt similarity index 100% rename from doc/src/compute_angle_local.txt rename to doc/txt/compute_angle_local.txt diff --git a/doc/src/compute_angmom_chunk.txt b/doc/txt/compute_angmom_chunk.txt similarity index 100% rename from doc/src/compute_angmom_chunk.txt rename to doc/txt/compute_angmom_chunk.txt diff --git a/doc/src/compute_basal_atom.txt b/doc/txt/compute_basal_atom.txt similarity index 100% rename from doc/src/compute_basal_atom.txt rename to doc/txt/compute_basal_atom.txt diff --git a/doc/src/compute_body_local.txt b/doc/txt/compute_body_local.txt similarity index 100% rename from doc/src/compute_body_local.txt rename to doc/txt/compute_body_local.txt diff --git a/doc/src/compute_bond.txt b/doc/txt/compute_bond.txt similarity index 100% rename from doc/src/compute_bond.txt rename to doc/txt/compute_bond.txt diff --git a/doc/src/compute_bond_local.txt b/doc/txt/compute_bond_local.txt similarity index 100% rename from doc/src/compute_bond_local.txt rename to doc/txt/compute_bond_local.txt diff --git a/doc/src/compute_centro_atom.txt b/doc/txt/compute_centro_atom.txt similarity index 100% rename from doc/src/compute_centro_atom.txt rename to doc/txt/compute_centro_atom.txt diff --git a/doc/src/compute_chunk_atom.txt b/doc/txt/compute_chunk_atom.txt similarity index 100% rename from doc/src/compute_chunk_atom.txt rename to doc/txt/compute_chunk_atom.txt diff --git a/doc/src/compute_chunk_spread_atom.txt b/doc/txt/compute_chunk_spread_atom.txt similarity index 100% rename from doc/src/compute_chunk_spread_atom.txt rename to doc/txt/compute_chunk_spread_atom.txt diff --git a/doc/src/compute_cluster_atom.txt b/doc/txt/compute_cluster_atom.txt similarity index 100% rename from doc/src/compute_cluster_atom.txt rename to doc/txt/compute_cluster_atom.txt diff --git a/doc/src/compute_cna_atom.txt b/doc/txt/compute_cna_atom.txt similarity index 100% rename from doc/src/compute_cna_atom.txt rename to doc/txt/compute_cna_atom.txt diff --git a/doc/src/compute_cnp_atom.txt b/doc/txt/compute_cnp_atom.txt similarity index 100% rename from doc/src/compute_cnp_atom.txt rename to doc/txt/compute_cnp_atom.txt diff --git a/doc/src/compute_com.txt b/doc/txt/compute_com.txt similarity index 100% rename from doc/src/compute_com.txt rename to doc/txt/compute_com.txt diff --git a/doc/src/compute_com_chunk.txt b/doc/txt/compute_com_chunk.txt similarity index 100% rename from doc/src/compute_com_chunk.txt rename to doc/txt/compute_com_chunk.txt diff --git a/doc/src/compute_contact_atom.txt b/doc/txt/compute_contact_atom.txt similarity index 100% rename from doc/src/compute_contact_atom.txt rename to doc/txt/compute_contact_atom.txt diff --git a/doc/src/compute_coord_atom.txt b/doc/txt/compute_coord_atom.txt similarity index 100% rename from doc/src/compute_coord_atom.txt rename to doc/txt/compute_coord_atom.txt diff --git a/doc/src/compute_damage_atom.txt b/doc/txt/compute_damage_atom.txt similarity index 100% rename from doc/src/compute_damage_atom.txt rename to doc/txt/compute_damage_atom.txt diff --git a/doc/src/compute_dihedral.txt b/doc/txt/compute_dihedral.txt similarity index 100% rename from doc/src/compute_dihedral.txt rename to doc/txt/compute_dihedral.txt diff --git a/doc/src/compute_dihedral_local.txt b/doc/txt/compute_dihedral_local.txt similarity index 100% rename from doc/src/compute_dihedral_local.txt rename to doc/txt/compute_dihedral_local.txt diff --git a/doc/src/compute_dilatation_atom.txt b/doc/txt/compute_dilatation_atom.txt similarity index 100% rename from doc/src/compute_dilatation_atom.txt rename to doc/txt/compute_dilatation_atom.txt diff --git a/doc/src/compute_dipole_chunk.txt b/doc/txt/compute_dipole_chunk.txt similarity index 100% rename from doc/src/compute_dipole_chunk.txt rename to doc/txt/compute_dipole_chunk.txt diff --git a/doc/src/compute_displace_atom.txt b/doc/txt/compute_displace_atom.txt similarity index 100% rename from doc/src/compute_displace_atom.txt rename to doc/txt/compute_displace_atom.txt diff --git a/doc/src/compute_dpd.txt b/doc/txt/compute_dpd.txt similarity index 100% rename from doc/src/compute_dpd.txt rename to doc/txt/compute_dpd.txt diff --git a/doc/src/compute_dpd_atom.txt b/doc/txt/compute_dpd_atom.txt similarity index 100% rename from doc/src/compute_dpd_atom.txt rename to doc/txt/compute_dpd_atom.txt diff --git a/doc/src/compute_edpd_temp_atom.txt b/doc/txt/compute_edpd_temp_atom.txt similarity index 100% rename from doc/src/compute_edpd_temp_atom.txt rename to doc/txt/compute_edpd_temp_atom.txt diff --git a/doc/src/compute_entropy_atom.txt b/doc/txt/compute_entropy_atom.txt similarity index 100% rename from doc/src/compute_entropy_atom.txt rename to doc/txt/compute_entropy_atom.txt diff --git a/doc/src/compute_erotate_asphere.txt b/doc/txt/compute_erotate_asphere.txt similarity index 100% rename from doc/src/compute_erotate_asphere.txt rename to doc/txt/compute_erotate_asphere.txt diff --git a/doc/src/compute_erotate_rigid.txt b/doc/txt/compute_erotate_rigid.txt similarity index 100% rename from doc/src/compute_erotate_rigid.txt rename to doc/txt/compute_erotate_rigid.txt diff --git a/doc/src/compute_erotate_sphere.txt b/doc/txt/compute_erotate_sphere.txt similarity index 100% rename from doc/src/compute_erotate_sphere.txt rename to doc/txt/compute_erotate_sphere.txt diff --git a/doc/src/compute_erotate_sphere_atom.txt b/doc/txt/compute_erotate_sphere_atom.txt similarity index 100% rename from doc/src/compute_erotate_sphere_atom.txt rename to doc/txt/compute_erotate_sphere_atom.txt diff --git a/doc/src/compute_event_displace.txt b/doc/txt/compute_event_displace.txt similarity index 100% rename from doc/src/compute_event_displace.txt rename to doc/txt/compute_event_displace.txt diff --git a/doc/src/compute_fep.txt b/doc/txt/compute_fep.txt similarity index 100% rename from doc/src/compute_fep.txt rename to doc/txt/compute_fep.txt diff --git a/doc/src/compute_global_atom.txt b/doc/txt/compute_global_atom.txt similarity index 100% rename from doc/src/compute_global_atom.txt rename to doc/txt/compute_global_atom.txt diff --git a/doc/src/compute_group_group.txt b/doc/txt/compute_group_group.txt similarity index 100% rename from doc/src/compute_group_group.txt rename to doc/txt/compute_group_group.txt diff --git a/doc/src/compute_gyration.txt b/doc/txt/compute_gyration.txt similarity index 100% rename from doc/src/compute_gyration.txt rename to doc/txt/compute_gyration.txt diff --git a/doc/src/compute_gyration_chunk.txt b/doc/txt/compute_gyration_chunk.txt similarity index 100% rename from doc/src/compute_gyration_chunk.txt rename to doc/txt/compute_gyration_chunk.txt diff --git a/doc/src/compute_gyration_shape.txt b/doc/txt/compute_gyration_shape.txt similarity index 100% rename from doc/src/compute_gyration_shape.txt rename to doc/txt/compute_gyration_shape.txt diff --git a/doc/src/compute_heat_flux.txt b/doc/txt/compute_heat_flux.txt similarity index 100% rename from doc/src/compute_heat_flux.txt rename to doc/txt/compute_heat_flux.txt diff --git a/doc/src/compute_hexorder_atom.txt b/doc/txt/compute_hexorder_atom.txt similarity index 100% rename from doc/src/compute_hexorder_atom.txt rename to doc/txt/compute_hexorder_atom.txt diff --git a/doc/src/compute_hma.txt b/doc/txt/compute_hma.txt similarity index 100% rename from doc/src/compute_hma.txt rename to doc/txt/compute_hma.txt diff --git a/doc/src/compute_improper.txt b/doc/txt/compute_improper.txt similarity index 100% rename from doc/src/compute_improper.txt rename to doc/txt/compute_improper.txt diff --git a/doc/src/compute_improper_local.txt b/doc/txt/compute_improper_local.txt similarity index 100% rename from doc/src/compute_improper_local.txt rename to doc/txt/compute_improper_local.txt diff --git a/doc/src/compute_inertia_chunk.txt b/doc/txt/compute_inertia_chunk.txt similarity index 100% rename from doc/src/compute_inertia_chunk.txt rename to doc/txt/compute_inertia_chunk.txt diff --git a/doc/src/compute_ke.txt b/doc/txt/compute_ke.txt similarity index 100% rename from doc/src/compute_ke.txt rename to doc/txt/compute_ke.txt diff --git a/doc/src/compute_ke_atom.txt b/doc/txt/compute_ke_atom.txt similarity index 100% rename from doc/src/compute_ke_atom.txt rename to doc/txt/compute_ke_atom.txt diff --git a/doc/src/compute_ke_atom_eff.txt b/doc/txt/compute_ke_atom_eff.txt similarity index 100% rename from doc/src/compute_ke_atom_eff.txt rename to doc/txt/compute_ke_atom_eff.txt diff --git a/doc/src/compute_ke_eff.txt b/doc/txt/compute_ke_eff.txt similarity index 100% rename from doc/src/compute_ke_eff.txt rename to doc/txt/compute_ke_eff.txt diff --git a/doc/src/compute_ke_rigid.txt b/doc/txt/compute_ke_rigid.txt similarity index 100% rename from doc/src/compute_ke_rigid.txt rename to doc/txt/compute_ke_rigid.txt diff --git a/doc/src/compute_meso_e_atom.txt b/doc/txt/compute_meso_e_atom.txt similarity index 100% rename from doc/src/compute_meso_e_atom.txt rename to doc/txt/compute_meso_e_atom.txt diff --git a/doc/src/compute_meso_rho_atom.txt b/doc/txt/compute_meso_rho_atom.txt similarity index 100% rename from doc/src/compute_meso_rho_atom.txt rename to doc/txt/compute_meso_rho_atom.txt diff --git a/doc/src/compute_meso_t_atom.txt b/doc/txt/compute_meso_t_atom.txt similarity index 100% rename from doc/src/compute_meso_t_atom.txt rename to doc/txt/compute_meso_t_atom.txt diff --git a/doc/src/compute_modify.txt b/doc/txt/compute_modify.txt similarity index 100% rename from doc/src/compute_modify.txt rename to doc/txt/compute_modify.txt diff --git a/doc/src/compute_momentum.txt b/doc/txt/compute_momentum.txt similarity index 100% rename from doc/src/compute_momentum.txt rename to doc/txt/compute_momentum.txt diff --git a/doc/src/compute_msd.txt b/doc/txt/compute_msd.txt similarity index 100% rename from doc/src/compute_msd.txt rename to doc/txt/compute_msd.txt diff --git a/doc/src/compute_msd_chunk.txt b/doc/txt/compute_msd_chunk.txt similarity index 100% rename from doc/src/compute_msd_chunk.txt rename to doc/txt/compute_msd_chunk.txt diff --git a/doc/src/compute_msd_nongauss.txt b/doc/txt/compute_msd_nongauss.txt similarity index 100% rename from doc/src/compute_msd_nongauss.txt rename to doc/txt/compute_msd_nongauss.txt diff --git a/doc/src/compute_omega_chunk.txt b/doc/txt/compute_omega_chunk.txt similarity index 100% rename from doc/src/compute_omega_chunk.txt rename to doc/txt/compute_omega_chunk.txt diff --git a/doc/src/compute_orientorder_atom.txt b/doc/txt/compute_orientorder_atom.txt similarity index 100% rename from doc/src/compute_orientorder_atom.txt rename to doc/txt/compute_orientorder_atom.txt diff --git a/doc/src/compute_pair.txt b/doc/txt/compute_pair.txt similarity index 100% rename from doc/src/compute_pair.txt rename to doc/txt/compute_pair.txt diff --git a/doc/src/compute_pair_local.txt b/doc/txt/compute_pair_local.txt similarity index 100% rename from doc/src/compute_pair_local.txt rename to doc/txt/compute_pair_local.txt diff --git a/doc/src/compute_pe.txt b/doc/txt/compute_pe.txt similarity index 100% rename from doc/src/compute_pe.txt rename to doc/txt/compute_pe.txt diff --git a/doc/src/compute_pe_atom.txt b/doc/txt/compute_pe_atom.txt similarity index 100% rename from doc/src/compute_pe_atom.txt rename to doc/txt/compute_pe_atom.txt diff --git a/doc/src/compute_plasticity_atom.txt b/doc/txt/compute_plasticity_atom.txt similarity index 100% rename from doc/src/compute_plasticity_atom.txt rename to doc/txt/compute_plasticity_atom.txt diff --git a/doc/src/compute_pressure.txt b/doc/txt/compute_pressure.txt similarity index 100% rename from doc/src/compute_pressure.txt rename to doc/txt/compute_pressure.txt diff --git a/doc/src/compute_pressure_cylinder.txt b/doc/txt/compute_pressure_cylinder.txt similarity index 100% rename from doc/src/compute_pressure_cylinder.txt rename to doc/txt/compute_pressure_cylinder.txt diff --git a/doc/src/compute_pressure_uef.txt b/doc/txt/compute_pressure_uef.txt similarity index 100% rename from doc/src/compute_pressure_uef.txt rename to doc/txt/compute_pressure_uef.txt diff --git a/doc/src/compute_property_atom.txt b/doc/txt/compute_property_atom.txt similarity index 100% rename from doc/src/compute_property_atom.txt rename to doc/txt/compute_property_atom.txt diff --git a/doc/src/compute_property_chunk.txt b/doc/txt/compute_property_chunk.txt similarity index 100% rename from doc/src/compute_property_chunk.txt rename to doc/txt/compute_property_chunk.txt diff --git a/doc/src/compute_property_local.txt b/doc/txt/compute_property_local.txt similarity index 100% rename from doc/src/compute_property_local.txt rename to doc/txt/compute_property_local.txt diff --git a/doc/src/compute_ptm_atom.txt b/doc/txt/compute_ptm_atom.txt similarity index 100% rename from doc/src/compute_ptm_atom.txt rename to doc/txt/compute_ptm_atom.txt diff --git a/doc/src/compute_rdf.txt b/doc/txt/compute_rdf.txt similarity index 100% rename from doc/src/compute_rdf.txt rename to doc/txt/compute_rdf.txt diff --git a/doc/src/compute_reduce.txt b/doc/txt/compute_reduce.txt similarity index 100% rename from doc/src/compute_reduce.txt rename to doc/txt/compute_reduce.txt diff --git a/doc/src/compute_reduce_chunk.txt b/doc/txt/compute_reduce_chunk.txt similarity index 100% rename from doc/src/compute_reduce_chunk.txt rename to doc/txt/compute_reduce_chunk.txt diff --git a/doc/src/compute_rigid_local.txt b/doc/txt/compute_rigid_local.txt similarity index 100% rename from doc/src/compute_rigid_local.txt rename to doc/txt/compute_rigid_local.txt diff --git a/doc/src/compute_saed.txt b/doc/txt/compute_saed.txt similarity index 100% rename from doc/src/compute_saed.txt rename to doc/txt/compute_saed.txt diff --git a/doc/src/compute_slice.txt b/doc/txt/compute_slice.txt similarity index 100% rename from doc/src/compute_slice.txt rename to doc/txt/compute_slice.txt diff --git a/doc/src/compute_smd_contact_radius.txt b/doc/txt/compute_smd_contact_radius.txt similarity index 100% rename from doc/src/compute_smd_contact_radius.txt rename to doc/txt/compute_smd_contact_radius.txt diff --git a/doc/src/compute_smd_damage.txt b/doc/txt/compute_smd_damage.txt similarity index 100% rename from doc/src/compute_smd_damage.txt rename to doc/txt/compute_smd_damage.txt diff --git a/doc/src/compute_smd_hourglass_error.txt b/doc/txt/compute_smd_hourglass_error.txt similarity index 100% rename from doc/src/compute_smd_hourglass_error.txt rename to doc/txt/compute_smd_hourglass_error.txt diff --git a/doc/src/compute_smd_internal_energy.txt b/doc/txt/compute_smd_internal_energy.txt similarity index 100% rename from doc/src/compute_smd_internal_energy.txt rename to doc/txt/compute_smd_internal_energy.txt diff --git a/doc/src/compute_smd_plastic_strain.txt b/doc/txt/compute_smd_plastic_strain.txt similarity index 100% rename from doc/src/compute_smd_plastic_strain.txt rename to doc/txt/compute_smd_plastic_strain.txt diff --git a/doc/src/compute_smd_plastic_strain_rate.txt b/doc/txt/compute_smd_plastic_strain_rate.txt similarity index 100% rename from doc/src/compute_smd_plastic_strain_rate.txt rename to doc/txt/compute_smd_plastic_strain_rate.txt diff --git a/doc/src/compute_smd_rho.txt b/doc/txt/compute_smd_rho.txt similarity index 100% rename from doc/src/compute_smd_rho.txt rename to doc/txt/compute_smd_rho.txt diff --git a/doc/src/compute_smd_tlsph_defgrad.txt b/doc/txt/compute_smd_tlsph_defgrad.txt similarity index 100% rename from doc/src/compute_smd_tlsph_defgrad.txt rename to doc/txt/compute_smd_tlsph_defgrad.txt diff --git a/doc/src/compute_smd_tlsph_dt.txt b/doc/txt/compute_smd_tlsph_dt.txt similarity index 100% rename from doc/src/compute_smd_tlsph_dt.txt rename to doc/txt/compute_smd_tlsph_dt.txt diff --git a/doc/src/compute_smd_tlsph_num_neighs.txt b/doc/txt/compute_smd_tlsph_num_neighs.txt similarity index 100% rename from doc/src/compute_smd_tlsph_num_neighs.txt rename to doc/txt/compute_smd_tlsph_num_neighs.txt diff --git a/doc/src/compute_smd_tlsph_shape.txt b/doc/txt/compute_smd_tlsph_shape.txt similarity index 100% rename from doc/src/compute_smd_tlsph_shape.txt rename to doc/txt/compute_smd_tlsph_shape.txt diff --git a/doc/src/compute_smd_tlsph_strain.txt b/doc/txt/compute_smd_tlsph_strain.txt similarity index 100% rename from doc/src/compute_smd_tlsph_strain.txt rename to doc/txt/compute_smd_tlsph_strain.txt diff --git a/doc/src/compute_smd_tlsph_strain_rate.txt b/doc/txt/compute_smd_tlsph_strain_rate.txt similarity index 100% rename from doc/src/compute_smd_tlsph_strain_rate.txt rename to doc/txt/compute_smd_tlsph_strain_rate.txt diff --git a/doc/src/compute_smd_tlsph_stress.txt b/doc/txt/compute_smd_tlsph_stress.txt similarity index 100% rename from doc/src/compute_smd_tlsph_stress.txt rename to doc/txt/compute_smd_tlsph_stress.txt diff --git a/doc/src/compute_smd_triangle_vertices.txt b/doc/txt/compute_smd_triangle_vertices.txt similarity index 100% rename from doc/src/compute_smd_triangle_vertices.txt rename to doc/txt/compute_smd_triangle_vertices.txt diff --git a/doc/src/compute_smd_ulsph_num_neighs.txt b/doc/txt/compute_smd_ulsph_num_neighs.txt similarity index 100% rename from doc/src/compute_smd_ulsph_num_neighs.txt rename to doc/txt/compute_smd_ulsph_num_neighs.txt diff --git a/doc/src/compute_smd_ulsph_strain.txt b/doc/txt/compute_smd_ulsph_strain.txt similarity index 100% rename from doc/src/compute_smd_ulsph_strain.txt rename to doc/txt/compute_smd_ulsph_strain.txt diff --git a/doc/src/compute_smd_ulsph_strain_rate.txt b/doc/txt/compute_smd_ulsph_strain_rate.txt similarity index 100% rename from doc/src/compute_smd_ulsph_strain_rate.txt rename to doc/txt/compute_smd_ulsph_strain_rate.txt diff --git a/doc/src/compute_smd_ulsph_stress.txt b/doc/txt/compute_smd_ulsph_stress.txt similarity index 100% rename from doc/src/compute_smd_ulsph_stress.txt rename to doc/txt/compute_smd_ulsph_stress.txt diff --git a/doc/src/compute_smd_vol.txt b/doc/txt/compute_smd_vol.txt similarity index 100% rename from doc/src/compute_smd_vol.txt rename to doc/txt/compute_smd_vol.txt diff --git a/doc/src/compute_sna_atom.txt b/doc/txt/compute_sna_atom.txt similarity index 100% rename from doc/src/compute_sna_atom.txt rename to doc/txt/compute_sna_atom.txt diff --git a/doc/src/compute_spin.txt b/doc/txt/compute_spin.txt similarity index 100% rename from doc/src/compute_spin.txt rename to doc/txt/compute_spin.txt diff --git a/doc/src/compute_stress_atom.txt b/doc/txt/compute_stress_atom.txt similarity index 100% rename from doc/src/compute_stress_atom.txt rename to doc/txt/compute_stress_atom.txt diff --git a/doc/src/compute_stress_mop.txt b/doc/txt/compute_stress_mop.txt similarity index 100% rename from doc/src/compute_stress_mop.txt rename to doc/txt/compute_stress_mop.txt diff --git a/doc/src/compute_tally.txt b/doc/txt/compute_tally.txt similarity index 100% rename from doc/src/compute_tally.txt rename to doc/txt/compute_tally.txt diff --git a/doc/src/compute_tdpd_cc_atom.txt b/doc/txt/compute_tdpd_cc_atom.txt similarity index 100% rename from doc/src/compute_tdpd_cc_atom.txt rename to doc/txt/compute_tdpd_cc_atom.txt diff --git a/doc/src/compute_temp.txt b/doc/txt/compute_temp.txt similarity index 100% rename from doc/src/compute_temp.txt rename to doc/txt/compute_temp.txt diff --git a/doc/src/compute_temp_asphere.txt b/doc/txt/compute_temp_asphere.txt similarity index 100% rename from doc/src/compute_temp_asphere.txt rename to doc/txt/compute_temp_asphere.txt diff --git a/doc/src/compute_temp_body.txt b/doc/txt/compute_temp_body.txt similarity index 100% rename from doc/src/compute_temp_body.txt rename to doc/txt/compute_temp_body.txt diff --git a/doc/src/compute_temp_chunk.txt b/doc/txt/compute_temp_chunk.txt similarity index 100% rename from doc/src/compute_temp_chunk.txt rename to doc/txt/compute_temp_chunk.txt diff --git a/doc/src/compute_temp_com.txt b/doc/txt/compute_temp_com.txt similarity index 100% rename from doc/src/compute_temp_com.txt rename to doc/txt/compute_temp_com.txt diff --git a/doc/src/compute_temp_cs.txt b/doc/txt/compute_temp_cs.txt similarity index 100% rename from doc/src/compute_temp_cs.txt rename to doc/txt/compute_temp_cs.txt diff --git a/doc/src/compute_temp_deform.txt b/doc/txt/compute_temp_deform.txt similarity index 100% rename from doc/src/compute_temp_deform.txt rename to doc/txt/compute_temp_deform.txt diff --git a/doc/src/compute_temp_deform_eff.txt b/doc/txt/compute_temp_deform_eff.txt similarity index 100% rename from doc/src/compute_temp_deform_eff.txt rename to doc/txt/compute_temp_deform_eff.txt diff --git a/doc/src/compute_temp_drude.txt b/doc/txt/compute_temp_drude.txt similarity index 100% rename from doc/src/compute_temp_drude.txt rename to doc/txt/compute_temp_drude.txt diff --git a/doc/src/compute_temp_eff.txt b/doc/txt/compute_temp_eff.txt similarity index 100% rename from doc/src/compute_temp_eff.txt rename to doc/txt/compute_temp_eff.txt diff --git a/doc/src/compute_temp_partial.txt b/doc/txt/compute_temp_partial.txt similarity index 100% rename from doc/src/compute_temp_partial.txt rename to doc/txt/compute_temp_partial.txt diff --git a/doc/src/compute_temp_profile.txt b/doc/txt/compute_temp_profile.txt similarity index 100% rename from doc/src/compute_temp_profile.txt rename to doc/txt/compute_temp_profile.txt diff --git a/doc/src/compute_temp_ramp.txt b/doc/txt/compute_temp_ramp.txt similarity index 100% rename from doc/src/compute_temp_ramp.txt rename to doc/txt/compute_temp_ramp.txt diff --git a/doc/src/compute_temp_region.txt b/doc/txt/compute_temp_region.txt similarity index 100% rename from doc/src/compute_temp_region.txt rename to doc/txt/compute_temp_region.txt diff --git a/doc/src/compute_temp_region_eff.txt b/doc/txt/compute_temp_region_eff.txt similarity index 100% rename from doc/src/compute_temp_region_eff.txt rename to doc/txt/compute_temp_region_eff.txt diff --git a/doc/src/compute_temp_rotate.txt b/doc/txt/compute_temp_rotate.txt similarity index 100% rename from doc/src/compute_temp_rotate.txt rename to doc/txt/compute_temp_rotate.txt diff --git a/doc/src/compute_temp_sphere.txt b/doc/txt/compute_temp_sphere.txt similarity index 100% rename from doc/src/compute_temp_sphere.txt rename to doc/txt/compute_temp_sphere.txt diff --git a/doc/src/compute_temp_uef.txt b/doc/txt/compute_temp_uef.txt similarity index 100% rename from doc/src/compute_temp_uef.txt rename to doc/txt/compute_temp_uef.txt diff --git a/doc/src/compute_ti.txt b/doc/txt/compute_ti.txt similarity index 100% rename from doc/src/compute_ti.txt rename to doc/txt/compute_ti.txt diff --git a/doc/src/compute_torque_chunk.txt b/doc/txt/compute_torque_chunk.txt similarity index 100% rename from doc/src/compute_torque_chunk.txt rename to doc/txt/compute_torque_chunk.txt diff --git a/doc/src/compute_vacf.txt b/doc/txt/compute_vacf.txt similarity index 100% rename from doc/src/compute_vacf.txt rename to doc/txt/compute_vacf.txt diff --git a/doc/src/compute_vcm_chunk.txt b/doc/txt/compute_vcm_chunk.txt similarity index 100% rename from doc/src/compute_vcm_chunk.txt rename to doc/txt/compute_vcm_chunk.txt diff --git a/doc/src/compute_voronoi_atom.txt b/doc/txt/compute_voronoi_atom.txt similarity index 100% rename from doc/src/compute_voronoi_atom.txt rename to doc/txt/compute_voronoi_atom.txt diff --git a/doc/src/compute_xrd.txt b/doc/txt/compute_xrd.txt similarity index 100% rename from doc/src/compute_xrd.txt rename to doc/txt/compute_xrd.txt diff --git a/doc/src/computes.txt b/doc/txt/computes.txt similarity index 100% rename from doc/src/computes.txt rename to doc/txt/computes.txt diff --git a/doc/src/create_atoms.txt b/doc/txt/create_atoms.txt similarity index 100% rename from doc/src/create_atoms.txt rename to doc/txt/create_atoms.txt diff --git a/doc/src/create_bonds.txt b/doc/txt/create_bonds.txt similarity index 100% rename from doc/src/create_bonds.txt rename to doc/txt/create_bonds.txt diff --git a/doc/src/create_box.txt b/doc/txt/create_box.txt similarity index 100% rename from doc/src/create_box.txt rename to doc/txt/create_box.txt diff --git a/doc/src/delete_atoms.txt b/doc/txt/delete_atoms.txt similarity index 100% rename from doc/src/delete_atoms.txt rename to doc/txt/delete_atoms.txt diff --git a/doc/src/delete_bonds.txt b/doc/txt/delete_bonds.txt similarity index 100% rename from doc/src/delete_bonds.txt rename to doc/txt/delete_bonds.txt diff --git a/doc/src/dielectric.txt b/doc/txt/dielectric.txt similarity index 100% rename from doc/src/dielectric.txt rename to doc/txt/dielectric.txt diff --git a/doc/src/dihedral_charmm.txt b/doc/txt/dihedral_charmm.txt similarity index 100% rename from doc/src/dihedral_charmm.txt rename to doc/txt/dihedral_charmm.txt diff --git a/doc/src/dihedral_class2.txt b/doc/txt/dihedral_class2.txt similarity index 100% rename from doc/src/dihedral_class2.txt rename to doc/txt/dihedral_class2.txt diff --git a/doc/src/dihedral_coeff.txt b/doc/txt/dihedral_coeff.txt similarity index 100% rename from doc/src/dihedral_coeff.txt rename to doc/txt/dihedral_coeff.txt diff --git a/doc/src/dihedral_cosine_shift_exp.txt b/doc/txt/dihedral_cosine_shift_exp.txt similarity index 100% rename from doc/src/dihedral_cosine_shift_exp.txt rename to doc/txt/dihedral_cosine_shift_exp.txt diff --git a/doc/src/dihedral_fourier.txt b/doc/txt/dihedral_fourier.txt similarity index 100% rename from doc/src/dihedral_fourier.txt rename to doc/txt/dihedral_fourier.txt diff --git a/doc/src/dihedral_harmonic.txt b/doc/txt/dihedral_harmonic.txt similarity index 100% rename from doc/src/dihedral_harmonic.txt rename to doc/txt/dihedral_harmonic.txt diff --git a/doc/src/dihedral_helix.txt b/doc/txt/dihedral_helix.txt similarity index 100% rename from doc/src/dihedral_helix.txt rename to doc/txt/dihedral_helix.txt diff --git a/doc/src/dihedral_hybrid.txt b/doc/txt/dihedral_hybrid.txt similarity index 100% rename from doc/src/dihedral_hybrid.txt rename to doc/txt/dihedral_hybrid.txt diff --git a/doc/src/dihedral_multi_harmonic.txt b/doc/txt/dihedral_multi_harmonic.txt similarity index 100% rename from doc/src/dihedral_multi_harmonic.txt rename to doc/txt/dihedral_multi_harmonic.txt diff --git a/doc/src/dihedral_nharmonic.txt b/doc/txt/dihedral_nharmonic.txt similarity index 100% rename from doc/src/dihedral_nharmonic.txt rename to doc/txt/dihedral_nharmonic.txt diff --git a/doc/src/dihedral_none.txt b/doc/txt/dihedral_none.txt similarity index 100% rename from doc/src/dihedral_none.txt rename to doc/txt/dihedral_none.txt diff --git a/doc/src/dihedral_opls.txt b/doc/txt/dihedral_opls.txt similarity index 100% rename from doc/src/dihedral_opls.txt rename to doc/txt/dihedral_opls.txt diff --git a/doc/src/dihedral_quadratic.txt b/doc/txt/dihedral_quadratic.txt similarity index 100% rename from doc/src/dihedral_quadratic.txt rename to doc/txt/dihedral_quadratic.txt diff --git a/doc/src/dihedral_spherical.txt b/doc/txt/dihedral_spherical.txt similarity index 100% rename from doc/src/dihedral_spherical.txt rename to doc/txt/dihedral_spherical.txt diff --git a/doc/src/dihedral_style.txt b/doc/txt/dihedral_style.txt similarity index 100% rename from doc/src/dihedral_style.txt rename to doc/txt/dihedral_style.txt diff --git a/doc/src/dihedral_table.txt b/doc/txt/dihedral_table.txt similarity index 100% rename from doc/src/dihedral_table.txt rename to doc/txt/dihedral_table.txt diff --git a/doc/src/dihedral_table_cut.txt b/doc/txt/dihedral_table_cut.txt similarity index 100% rename from doc/src/dihedral_table_cut.txt rename to doc/txt/dihedral_table_cut.txt diff --git a/doc/src/dihedral_zero.txt b/doc/txt/dihedral_zero.txt similarity index 100% rename from doc/src/dihedral_zero.txt rename to doc/txt/dihedral_zero.txt diff --git a/doc/src/dihedrals.txt b/doc/txt/dihedrals.txt similarity index 100% rename from doc/src/dihedrals.txt rename to doc/txt/dihedrals.txt diff --git a/doc/src/dimension.txt b/doc/txt/dimension.txt similarity index 100% rename from doc/src/dimension.txt rename to doc/txt/dimension.txt diff --git a/doc/src/displace_atoms.txt b/doc/txt/displace_atoms.txt similarity index 100% rename from doc/src/displace_atoms.txt rename to doc/txt/displace_atoms.txt diff --git a/doc/src/dump.txt b/doc/txt/dump.txt similarity index 100% rename from doc/src/dump.txt rename to doc/txt/dump.txt diff --git a/doc/src/dump_adios.txt b/doc/txt/dump_adios.txt similarity index 100% rename from doc/src/dump_adios.txt rename to doc/txt/dump_adios.txt diff --git a/doc/src/dump_cfg_uef.txt b/doc/txt/dump_cfg_uef.txt similarity index 100% rename from doc/src/dump_cfg_uef.txt rename to doc/txt/dump_cfg_uef.txt diff --git a/doc/src/dump_h5md.txt b/doc/txt/dump_h5md.txt similarity index 100% rename from doc/src/dump_h5md.txt rename to doc/txt/dump_h5md.txt diff --git a/doc/src/dump_image.txt b/doc/txt/dump_image.txt similarity index 100% rename from doc/src/dump_image.txt rename to doc/txt/dump_image.txt diff --git a/doc/src/dump_modify.txt b/doc/txt/dump_modify.txt similarity index 100% rename from doc/src/dump_modify.txt rename to doc/txt/dump_modify.txt diff --git a/doc/src/dump_molfile.txt b/doc/txt/dump_molfile.txt similarity index 100% rename from doc/src/dump_molfile.txt rename to doc/txt/dump_molfile.txt diff --git a/doc/src/dump_netcdf.txt b/doc/txt/dump_netcdf.txt similarity index 100% rename from doc/src/dump_netcdf.txt rename to doc/txt/dump_netcdf.txt diff --git a/doc/src/dump_vtk.txt b/doc/txt/dump_vtk.txt similarity index 100% rename from doc/src/dump_vtk.txt rename to doc/txt/dump_vtk.txt diff --git a/doc/src/dynamical_matrix.txt b/doc/txt/dynamical_matrix.txt similarity index 100% rename from doc/src/dynamical_matrix.txt rename to doc/txt/dynamical_matrix.txt diff --git a/doc/src/echo.txt b/doc/txt/echo.txt similarity index 100% rename from doc/src/echo.txt rename to doc/txt/echo.txt diff --git a/doc/src/fix.txt b/doc/txt/fix.txt similarity index 100% rename from doc/src/fix.txt rename to doc/txt/fix.txt diff --git a/doc/src/fix_adapt.txt b/doc/txt/fix_adapt.txt similarity index 100% rename from doc/src/fix_adapt.txt rename to doc/txt/fix_adapt.txt diff --git a/doc/src/fix_adapt_fep.txt b/doc/txt/fix_adapt_fep.txt similarity index 100% rename from doc/src/fix_adapt_fep.txt rename to doc/txt/fix_adapt_fep.txt diff --git a/doc/src/fix_addforce.txt b/doc/txt/fix_addforce.txt similarity index 100% rename from doc/src/fix_addforce.txt rename to doc/txt/fix_addforce.txt diff --git a/doc/src/fix_addtorque.txt b/doc/txt/fix_addtorque.txt similarity index 100% rename from doc/src/fix_addtorque.txt rename to doc/txt/fix_addtorque.txt diff --git a/doc/src/fix_append_atoms.txt b/doc/txt/fix_append_atoms.txt similarity index 100% rename from doc/src/fix_append_atoms.txt rename to doc/txt/fix_append_atoms.txt diff --git a/doc/src/fix_atc.txt b/doc/txt/fix_atc.txt similarity index 100% rename from doc/src/fix_atc.txt rename to doc/txt/fix_atc.txt diff --git a/doc/src/fix_atom_swap.txt b/doc/txt/fix_atom_swap.txt similarity index 100% rename from doc/src/fix_atom_swap.txt rename to doc/txt/fix_atom_swap.txt diff --git a/doc/src/fix_ave_atom.txt b/doc/txt/fix_ave_atom.txt similarity index 100% rename from doc/src/fix_ave_atom.txt rename to doc/txt/fix_ave_atom.txt diff --git a/doc/src/fix_ave_chunk.txt b/doc/txt/fix_ave_chunk.txt similarity index 100% rename from doc/src/fix_ave_chunk.txt rename to doc/txt/fix_ave_chunk.txt diff --git a/doc/src/fix_ave_correlate.txt b/doc/txt/fix_ave_correlate.txt similarity index 100% rename from doc/src/fix_ave_correlate.txt rename to doc/txt/fix_ave_correlate.txt diff --git a/doc/src/fix_ave_correlate_long.txt b/doc/txt/fix_ave_correlate_long.txt similarity index 100% rename from doc/src/fix_ave_correlate_long.txt rename to doc/txt/fix_ave_correlate_long.txt diff --git a/doc/src/fix_ave_histo.txt b/doc/txt/fix_ave_histo.txt similarity index 100% rename from doc/src/fix_ave_histo.txt rename to doc/txt/fix_ave_histo.txt diff --git a/doc/src/fix_ave_time.txt b/doc/txt/fix_ave_time.txt similarity index 100% rename from doc/src/fix_ave_time.txt rename to doc/txt/fix_ave_time.txt diff --git a/doc/src/fix_aveforce.txt b/doc/txt/fix_aveforce.txt similarity index 100% rename from doc/src/fix_aveforce.txt rename to doc/txt/fix_aveforce.txt diff --git a/doc/src/fix_balance.txt b/doc/txt/fix_balance.txt similarity index 100% rename from doc/src/fix_balance.txt rename to doc/txt/fix_balance.txt diff --git a/doc/src/fix_bocs.txt b/doc/txt/fix_bocs.txt similarity index 100% rename from doc/src/fix_bocs.txt rename to doc/txt/fix_bocs.txt diff --git a/doc/src/fix_bond_break.txt b/doc/txt/fix_bond_break.txt similarity index 100% rename from doc/src/fix_bond_break.txt rename to doc/txt/fix_bond_break.txt diff --git a/doc/src/fix_bond_create.txt b/doc/txt/fix_bond_create.txt similarity index 100% rename from doc/src/fix_bond_create.txt rename to doc/txt/fix_bond_create.txt diff --git a/doc/src/fix_bond_react.txt b/doc/txt/fix_bond_react.txt similarity index 100% rename from doc/src/fix_bond_react.txt rename to doc/txt/fix_bond_react.txt diff --git a/doc/src/fix_bond_swap.txt b/doc/txt/fix_bond_swap.txt similarity index 100% rename from doc/src/fix_bond_swap.txt rename to doc/txt/fix_bond_swap.txt diff --git a/doc/src/fix_box_relax.txt b/doc/txt/fix_box_relax.txt similarity index 100% rename from doc/src/fix_box_relax.txt rename to doc/txt/fix_box_relax.txt diff --git a/doc/src/fix_client_md.txt b/doc/txt/fix_client_md.txt similarity index 100% rename from doc/src/fix_client_md.txt rename to doc/txt/fix_client_md.txt diff --git a/doc/src/fix_cmap.txt b/doc/txt/fix_cmap.txt similarity index 100% rename from doc/src/fix_cmap.txt rename to doc/txt/fix_cmap.txt diff --git a/doc/src/fix_colvars.txt b/doc/txt/fix_colvars.txt similarity index 100% rename from doc/src/fix_colvars.txt rename to doc/txt/fix_colvars.txt diff --git a/doc/src/fix_controller.txt b/doc/txt/fix_controller.txt similarity index 100% rename from doc/src/fix_controller.txt rename to doc/txt/fix_controller.txt diff --git a/doc/src/fix_deform.txt b/doc/txt/fix_deform.txt similarity index 100% rename from doc/src/fix_deform.txt rename to doc/txt/fix_deform.txt diff --git a/doc/src/fix_deposit.txt b/doc/txt/fix_deposit.txt similarity index 100% rename from doc/src/fix_deposit.txt rename to doc/txt/fix_deposit.txt diff --git a/doc/src/fix_dpd_energy.txt b/doc/txt/fix_dpd_energy.txt similarity index 100% rename from doc/src/fix_dpd_energy.txt rename to doc/txt/fix_dpd_energy.txt diff --git a/doc/src/fix_dpd_source.txt b/doc/txt/fix_dpd_source.txt similarity index 100% rename from doc/src/fix_dpd_source.txt rename to doc/txt/fix_dpd_source.txt diff --git a/doc/src/fix_drag.txt b/doc/txt/fix_drag.txt similarity index 100% rename from doc/src/fix_drag.txt rename to doc/txt/fix_drag.txt diff --git a/doc/src/fix_drude.txt b/doc/txt/fix_drude.txt similarity index 100% rename from doc/src/fix_drude.txt rename to doc/txt/fix_drude.txt diff --git a/doc/src/fix_drude_transform.txt b/doc/txt/fix_drude_transform.txt similarity index 100% rename from doc/src/fix_drude_transform.txt rename to doc/txt/fix_drude_transform.txt diff --git a/doc/src/fix_dt_reset.txt b/doc/txt/fix_dt_reset.txt similarity index 100% rename from doc/src/fix_dt_reset.txt rename to doc/txt/fix_dt_reset.txt diff --git a/doc/src/fix_efield.txt b/doc/txt/fix_efield.txt similarity index 100% rename from doc/src/fix_efield.txt rename to doc/txt/fix_efield.txt diff --git a/doc/src/fix_ehex.txt b/doc/txt/fix_ehex.txt similarity index 100% rename from doc/src/fix_ehex.txt rename to doc/txt/fix_ehex.txt diff --git a/doc/src/fix_electron_stopping.txt b/doc/txt/fix_electron_stopping.txt similarity index 100% rename from doc/src/fix_electron_stopping.txt rename to doc/txt/fix_electron_stopping.txt diff --git a/doc/src/fix_enforce2d.txt b/doc/txt/fix_enforce2d.txt similarity index 100% rename from doc/src/fix_enforce2d.txt rename to doc/txt/fix_enforce2d.txt diff --git a/doc/src/fix_eos_cv.txt b/doc/txt/fix_eos_cv.txt similarity index 100% rename from doc/src/fix_eos_cv.txt rename to doc/txt/fix_eos_cv.txt diff --git a/doc/src/fix_eos_table.txt b/doc/txt/fix_eos_table.txt similarity index 100% rename from doc/src/fix_eos_table.txt rename to doc/txt/fix_eos_table.txt diff --git a/doc/src/fix_eos_table_rx.txt b/doc/txt/fix_eos_table_rx.txt similarity index 100% rename from doc/src/fix_eos_table_rx.txt rename to doc/txt/fix_eos_table_rx.txt diff --git a/doc/src/fix_evaporate.txt b/doc/txt/fix_evaporate.txt similarity index 100% rename from doc/src/fix_evaporate.txt rename to doc/txt/fix_evaporate.txt diff --git a/doc/src/fix_external.txt b/doc/txt/fix_external.txt similarity index 100% rename from doc/src/fix_external.txt rename to doc/txt/fix_external.txt diff --git a/doc/src/fix_ffl.txt b/doc/txt/fix_ffl.txt similarity index 100% rename from doc/src/fix_ffl.txt rename to doc/txt/fix_ffl.txt diff --git a/doc/src/fix_filter_corotate.txt b/doc/txt/fix_filter_corotate.txt similarity index 100% rename from doc/src/fix_filter_corotate.txt rename to doc/txt/fix_filter_corotate.txt diff --git a/doc/src/fix_flow_gauss.txt b/doc/txt/fix_flow_gauss.txt similarity index 100% rename from doc/src/fix_flow_gauss.txt rename to doc/txt/fix_flow_gauss.txt diff --git a/doc/src/fix_freeze.txt b/doc/txt/fix_freeze.txt similarity index 100% rename from doc/src/fix_freeze.txt rename to doc/txt/fix_freeze.txt diff --git a/doc/src/fix_gcmc.txt b/doc/txt/fix_gcmc.txt similarity index 100% rename from doc/src/fix_gcmc.txt rename to doc/txt/fix_gcmc.txt diff --git a/doc/src/fix_gld.txt b/doc/txt/fix_gld.txt similarity index 100% rename from doc/src/fix_gld.txt rename to doc/txt/fix_gld.txt diff --git a/doc/src/fix_gle.txt b/doc/txt/fix_gle.txt similarity index 100% rename from doc/src/fix_gle.txt rename to doc/txt/fix_gle.txt diff --git a/doc/src/fix_gravity.txt b/doc/txt/fix_gravity.txt similarity index 100% rename from doc/src/fix_gravity.txt rename to doc/txt/fix_gravity.txt diff --git a/doc/src/fix_grem.txt b/doc/txt/fix_grem.txt similarity index 100% rename from doc/src/fix_grem.txt rename to doc/txt/fix_grem.txt diff --git a/doc/src/fix_halt.txt b/doc/txt/fix_halt.txt similarity index 100% rename from doc/src/fix_halt.txt rename to doc/txt/fix_halt.txt diff --git a/doc/src/fix_heat.txt b/doc/txt/fix_heat.txt similarity index 100% rename from doc/src/fix_heat.txt rename to doc/txt/fix_heat.txt diff --git a/doc/src/fix_hyper_global.txt b/doc/txt/fix_hyper_global.txt similarity index 100% rename from doc/src/fix_hyper_global.txt rename to doc/txt/fix_hyper_global.txt diff --git a/doc/src/fix_hyper_local.txt b/doc/txt/fix_hyper_local.txt similarity index 100% rename from doc/src/fix_hyper_local.txt rename to doc/txt/fix_hyper_local.txt diff --git a/doc/src/fix_imd.txt b/doc/txt/fix_imd.txt similarity index 100% rename from doc/src/fix_imd.txt rename to doc/txt/fix_imd.txt diff --git a/doc/src/fix_indent.txt b/doc/txt/fix_indent.txt similarity index 100% rename from doc/src/fix_indent.txt rename to doc/txt/fix_indent.txt diff --git a/doc/src/fix_ipi.txt b/doc/txt/fix_ipi.txt similarity index 100% rename from doc/src/fix_ipi.txt rename to doc/txt/fix_ipi.txt diff --git a/doc/src/fix_langevin.txt b/doc/txt/fix_langevin.txt similarity index 100% rename from doc/src/fix_langevin.txt rename to doc/txt/fix_langevin.txt diff --git a/doc/src/fix_langevin_drude.txt b/doc/txt/fix_langevin_drude.txt similarity index 100% rename from doc/src/fix_langevin_drude.txt rename to doc/txt/fix_langevin_drude.txt diff --git a/doc/src/fix_langevin_eff.txt b/doc/txt/fix_langevin_eff.txt similarity index 100% rename from doc/src/fix_langevin_eff.txt rename to doc/txt/fix_langevin_eff.txt diff --git a/doc/src/fix_langevin_spin.txt b/doc/txt/fix_langevin_spin.txt similarity index 100% rename from doc/src/fix_langevin_spin.txt rename to doc/txt/fix_langevin_spin.txt diff --git a/doc/src/fix_latte.txt b/doc/txt/fix_latte.txt similarity index 100% rename from doc/src/fix_latte.txt rename to doc/txt/fix_latte.txt diff --git a/doc/src/fix_lb_fluid.txt b/doc/txt/fix_lb_fluid.txt similarity index 100% rename from doc/src/fix_lb_fluid.txt rename to doc/txt/fix_lb_fluid.txt diff --git a/doc/src/fix_lb_momentum.txt b/doc/txt/fix_lb_momentum.txt similarity index 100% rename from doc/src/fix_lb_momentum.txt rename to doc/txt/fix_lb_momentum.txt diff --git a/doc/src/fix_lb_pc.txt b/doc/txt/fix_lb_pc.txt similarity index 100% rename from doc/src/fix_lb_pc.txt rename to doc/txt/fix_lb_pc.txt diff --git a/doc/src/fix_lb_rigid_pc_sphere.txt b/doc/txt/fix_lb_rigid_pc_sphere.txt similarity index 100% rename from doc/src/fix_lb_rigid_pc_sphere.txt rename to doc/txt/fix_lb_rigid_pc_sphere.txt diff --git a/doc/src/fix_lb_viscous.txt b/doc/txt/fix_lb_viscous.txt similarity index 100% rename from doc/src/fix_lb_viscous.txt rename to doc/txt/fix_lb_viscous.txt diff --git a/doc/src/fix_lineforce.txt b/doc/txt/fix_lineforce.txt similarity index 100% rename from doc/src/fix_lineforce.txt rename to doc/txt/fix_lineforce.txt diff --git a/doc/src/fix_manifoldforce.txt b/doc/txt/fix_manifoldforce.txt similarity index 100% rename from doc/src/fix_manifoldforce.txt rename to doc/txt/fix_manifoldforce.txt diff --git a/doc/src/fix_meso.txt b/doc/txt/fix_meso.txt similarity index 100% rename from doc/src/fix_meso.txt rename to doc/txt/fix_meso.txt diff --git a/doc/src/fix_meso_move.txt b/doc/txt/fix_meso_move.txt similarity index 100% rename from doc/src/fix_meso_move.txt rename to doc/txt/fix_meso_move.txt diff --git a/doc/src/fix_meso_stationary.txt b/doc/txt/fix_meso_stationary.txt similarity index 100% rename from doc/src/fix_meso_stationary.txt rename to doc/txt/fix_meso_stationary.txt diff --git a/doc/src/fix_modify.txt b/doc/txt/fix_modify.txt similarity index 100% rename from doc/src/fix_modify.txt rename to doc/txt/fix_modify.txt diff --git a/doc/src/fix_momentum.txt b/doc/txt/fix_momentum.txt similarity index 100% rename from doc/src/fix_momentum.txt rename to doc/txt/fix_momentum.txt diff --git a/doc/src/fix_move.txt b/doc/txt/fix_move.txt similarity index 100% rename from doc/src/fix_move.txt rename to doc/txt/fix_move.txt diff --git a/doc/src/fix_mscg.txt b/doc/txt/fix_mscg.txt similarity index 100% rename from doc/src/fix_mscg.txt rename to doc/txt/fix_mscg.txt diff --git a/doc/src/fix_msst.txt b/doc/txt/fix_msst.txt similarity index 100% rename from doc/src/fix_msst.txt rename to doc/txt/fix_msst.txt diff --git a/doc/src/fix_mvv_dpd.txt b/doc/txt/fix_mvv_dpd.txt similarity index 100% rename from doc/src/fix_mvv_dpd.txt rename to doc/txt/fix_mvv_dpd.txt diff --git a/doc/src/fix_neb.txt b/doc/txt/fix_neb.txt similarity index 100% rename from doc/src/fix_neb.txt rename to doc/txt/fix_neb.txt diff --git a/doc/src/fix_neb_spin.txt b/doc/txt/fix_neb_spin.txt similarity index 100% rename from doc/src/fix_neb_spin.txt rename to doc/txt/fix_neb_spin.txt diff --git a/doc/src/fix_nh.txt b/doc/txt/fix_nh.txt similarity index 100% rename from doc/src/fix_nh.txt rename to doc/txt/fix_nh.txt diff --git a/doc/src/fix_nh_eff.txt b/doc/txt/fix_nh_eff.txt similarity index 100% rename from doc/src/fix_nh_eff.txt rename to doc/txt/fix_nh_eff.txt diff --git a/doc/src/fix_nh_uef.txt b/doc/txt/fix_nh_uef.txt similarity index 100% rename from doc/src/fix_nh_uef.txt rename to doc/txt/fix_nh_uef.txt diff --git a/doc/src/fix_nph_asphere.txt b/doc/txt/fix_nph_asphere.txt similarity index 100% rename from doc/src/fix_nph_asphere.txt rename to doc/txt/fix_nph_asphere.txt diff --git a/doc/src/fix_nph_body.txt b/doc/txt/fix_nph_body.txt similarity index 100% rename from doc/src/fix_nph_body.txt rename to doc/txt/fix_nph_body.txt diff --git a/doc/src/fix_nph_sphere.txt b/doc/txt/fix_nph_sphere.txt similarity index 100% rename from doc/src/fix_nph_sphere.txt rename to doc/txt/fix_nph_sphere.txt diff --git a/doc/src/fix_nphug.txt b/doc/txt/fix_nphug.txt similarity index 100% rename from doc/src/fix_nphug.txt rename to doc/txt/fix_nphug.txt diff --git a/doc/src/fix_npt_asphere.txt b/doc/txt/fix_npt_asphere.txt similarity index 100% rename from doc/src/fix_npt_asphere.txt rename to doc/txt/fix_npt_asphere.txt diff --git a/doc/src/fix_npt_body.txt b/doc/txt/fix_npt_body.txt similarity index 100% rename from doc/src/fix_npt_body.txt rename to doc/txt/fix_npt_body.txt diff --git a/doc/src/fix_npt_sphere.txt b/doc/txt/fix_npt_sphere.txt similarity index 100% rename from doc/src/fix_npt_sphere.txt rename to doc/txt/fix_npt_sphere.txt diff --git a/doc/src/fix_nve.txt b/doc/txt/fix_nve.txt similarity index 100% rename from doc/src/fix_nve.txt rename to doc/txt/fix_nve.txt diff --git a/doc/src/fix_nve_asphere.txt b/doc/txt/fix_nve_asphere.txt similarity index 100% rename from doc/src/fix_nve_asphere.txt rename to doc/txt/fix_nve_asphere.txt diff --git a/doc/src/fix_nve_asphere_noforce.txt b/doc/txt/fix_nve_asphere_noforce.txt similarity index 100% rename from doc/src/fix_nve_asphere_noforce.txt rename to doc/txt/fix_nve_asphere_noforce.txt diff --git a/doc/src/fix_nve_awpmd.txt b/doc/txt/fix_nve_awpmd.txt similarity index 100% rename from doc/src/fix_nve_awpmd.txt rename to doc/txt/fix_nve_awpmd.txt diff --git a/doc/src/fix_nve_body.txt b/doc/txt/fix_nve_body.txt similarity index 100% rename from doc/src/fix_nve_body.txt rename to doc/txt/fix_nve_body.txt diff --git a/doc/src/fix_nve_dot.txt b/doc/txt/fix_nve_dot.txt similarity index 100% rename from doc/src/fix_nve_dot.txt rename to doc/txt/fix_nve_dot.txt diff --git a/doc/src/fix_nve_dotc_langevin.txt b/doc/txt/fix_nve_dotc_langevin.txt similarity index 100% rename from doc/src/fix_nve_dotc_langevin.txt rename to doc/txt/fix_nve_dotc_langevin.txt diff --git a/doc/src/fix_nve_eff.txt b/doc/txt/fix_nve_eff.txt similarity index 100% rename from doc/src/fix_nve_eff.txt rename to doc/txt/fix_nve_eff.txt diff --git a/doc/src/fix_nve_limit.txt b/doc/txt/fix_nve_limit.txt similarity index 100% rename from doc/src/fix_nve_limit.txt rename to doc/txt/fix_nve_limit.txt diff --git a/doc/src/fix_nve_line.txt b/doc/txt/fix_nve_line.txt similarity index 100% rename from doc/src/fix_nve_line.txt rename to doc/txt/fix_nve_line.txt diff --git a/doc/src/fix_nve_manifold_rattle.txt b/doc/txt/fix_nve_manifold_rattle.txt similarity index 100% rename from doc/src/fix_nve_manifold_rattle.txt rename to doc/txt/fix_nve_manifold_rattle.txt diff --git a/doc/src/fix_nve_noforce.txt b/doc/txt/fix_nve_noforce.txt similarity index 100% rename from doc/src/fix_nve_noforce.txt rename to doc/txt/fix_nve_noforce.txt diff --git a/doc/src/fix_nve_sphere.txt b/doc/txt/fix_nve_sphere.txt similarity index 100% rename from doc/src/fix_nve_sphere.txt rename to doc/txt/fix_nve_sphere.txt diff --git a/doc/src/fix_nve_spin.txt b/doc/txt/fix_nve_spin.txt similarity index 100% rename from doc/src/fix_nve_spin.txt rename to doc/txt/fix_nve_spin.txt diff --git a/doc/src/fix_nve_tri.txt b/doc/txt/fix_nve_tri.txt similarity index 100% rename from doc/src/fix_nve_tri.txt rename to doc/txt/fix_nve_tri.txt diff --git a/doc/src/fix_nvk.txt b/doc/txt/fix_nvk.txt similarity index 100% rename from doc/src/fix_nvk.txt rename to doc/txt/fix_nvk.txt diff --git a/doc/src/fix_nvt_asphere.txt b/doc/txt/fix_nvt_asphere.txt similarity index 100% rename from doc/src/fix_nvt_asphere.txt rename to doc/txt/fix_nvt_asphere.txt diff --git a/doc/src/fix_nvt_body.txt b/doc/txt/fix_nvt_body.txt similarity index 100% rename from doc/src/fix_nvt_body.txt rename to doc/txt/fix_nvt_body.txt diff --git a/doc/src/fix_nvt_manifold_rattle.txt b/doc/txt/fix_nvt_manifold_rattle.txt similarity index 100% rename from doc/src/fix_nvt_manifold_rattle.txt rename to doc/txt/fix_nvt_manifold_rattle.txt diff --git a/doc/src/fix_nvt_sllod.txt b/doc/txt/fix_nvt_sllod.txt similarity index 100% rename from doc/src/fix_nvt_sllod.txt rename to doc/txt/fix_nvt_sllod.txt diff --git a/doc/src/fix_nvt_sllod_eff.txt b/doc/txt/fix_nvt_sllod_eff.txt similarity index 100% rename from doc/src/fix_nvt_sllod_eff.txt rename to doc/txt/fix_nvt_sllod_eff.txt diff --git a/doc/src/fix_nvt_sphere.txt b/doc/txt/fix_nvt_sphere.txt similarity index 100% rename from doc/src/fix_nvt_sphere.txt rename to doc/txt/fix_nvt_sphere.txt diff --git a/doc/src/fix_oneway.txt b/doc/txt/fix_oneway.txt similarity index 100% rename from doc/src/fix_oneway.txt rename to doc/txt/fix_oneway.txt diff --git a/doc/src/fix_orient.txt b/doc/txt/fix_orient.txt similarity index 100% rename from doc/src/fix_orient.txt rename to doc/txt/fix_orient.txt diff --git a/doc/src/fix_phonon.txt b/doc/txt/fix_phonon.txt similarity index 100% rename from doc/src/fix_phonon.txt rename to doc/txt/fix_phonon.txt diff --git a/doc/src/fix_pimd.txt b/doc/txt/fix_pimd.txt similarity index 100% rename from doc/src/fix_pimd.txt rename to doc/txt/fix_pimd.txt diff --git a/doc/src/fix_planeforce.txt b/doc/txt/fix_planeforce.txt similarity index 100% rename from doc/src/fix_planeforce.txt rename to doc/txt/fix_planeforce.txt diff --git a/doc/src/fix_plumed.txt b/doc/txt/fix_plumed.txt similarity index 100% rename from doc/src/fix_plumed.txt rename to doc/txt/fix_plumed.txt diff --git a/doc/src/fix_poems.txt b/doc/txt/fix_poems.txt similarity index 100% rename from doc/src/fix_poems.txt rename to doc/txt/fix_poems.txt diff --git a/doc/src/fix_pour.txt b/doc/txt/fix_pour.txt similarity index 100% rename from doc/src/fix_pour.txt rename to doc/txt/fix_pour.txt diff --git a/doc/src/fix_precession_spin.txt b/doc/txt/fix_precession_spin.txt similarity index 100% rename from doc/src/fix_precession_spin.txt rename to doc/txt/fix_precession_spin.txt diff --git a/doc/src/fix_press_berendsen.txt b/doc/txt/fix_press_berendsen.txt similarity index 100% rename from doc/src/fix_press_berendsen.txt rename to doc/txt/fix_press_berendsen.txt diff --git a/doc/src/fix_print.txt b/doc/txt/fix_print.txt similarity index 100% rename from doc/src/fix_print.txt rename to doc/txt/fix_print.txt diff --git a/doc/src/fix_property_atom.txt b/doc/txt/fix_property_atom.txt similarity index 100% rename from doc/src/fix_property_atom.txt rename to doc/txt/fix_property_atom.txt diff --git a/doc/src/fix_python_invoke.txt b/doc/txt/fix_python_invoke.txt similarity index 100% rename from doc/src/fix_python_invoke.txt rename to doc/txt/fix_python_invoke.txt diff --git a/doc/src/fix_python_move.txt b/doc/txt/fix_python_move.txt similarity index 100% rename from doc/src/fix_python_move.txt rename to doc/txt/fix_python_move.txt diff --git a/doc/src/fix_qbmsst.txt b/doc/txt/fix_qbmsst.txt similarity index 100% rename from doc/src/fix_qbmsst.txt rename to doc/txt/fix_qbmsst.txt diff --git a/doc/src/fix_qeq.txt b/doc/txt/fix_qeq.txt similarity index 100% rename from doc/src/fix_qeq.txt rename to doc/txt/fix_qeq.txt diff --git a/doc/src/fix_qeq_comb.txt b/doc/txt/fix_qeq_comb.txt similarity index 100% rename from doc/src/fix_qeq_comb.txt rename to doc/txt/fix_qeq_comb.txt diff --git a/doc/src/fix_qeq_reax.txt b/doc/txt/fix_qeq_reax.txt similarity index 100% rename from doc/src/fix_qeq_reax.txt rename to doc/txt/fix_qeq_reax.txt diff --git a/doc/src/fix_qmmm.txt b/doc/txt/fix_qmmm.txt similarity index 100% rename from doc/src/fix_qmmm.txt rename to doc/txt/fix_qmmm.txt diff --git a/doc/src/fix_qtb.txt b/doc/txt/fix_qtb.txt similarity index 100% rename from doc/src/fix_qtb.txt rename to doc/txt/fix_qtb.txt diff --git a/doc/src/fix_reaxc_bonds.txt b/doc/txt/fix_reaxc_bonds.txt similarity index 100% rename from doc/src/fix_reaxc_bonds.txt rename to doc/txt/fix_reaxc_bonds.txt diff --git a/doc/src/fix_reaxc_species.txt b/doc/txt/fix_reaxc_species.txt similarity index 100% rename from doc/src/fix_reaxc_species.txt rename to doc/txt/fix_reaxc_species.txt diff --git a/doc/src/fix_recenter.txt b/doc/txt/fix_recenter.txt similarity index 100% rename from doc/src/fix_recenter.txt rename to doc/txt/fix_recenter.txt diff --git a/doc/src/fix_restrain.txt b/doc/txt/fix_restrain.txt similarity index 100% rename from doc/src/fix_restrain.txt rename to doc/txt/fix_restrain.txt diff --git a/doc/src/fix_rhok.txt b/doc/txt/fix_rhok.txt similarity index 100% rename from doc/src/fix_rhok.txt rename to doc/txt/fix_rhok.txt diff --git a/doc/src/fix_rigid.txt b/doc/txt/fix_rigid.txt similarity index 100% rename from doc/src/fix_rigid.txt rename to doc/txt/fix_rigid.txt diff --git a/doc/src/fix_rigid_meso.txt b/doc/txt/fix_rigid_meso.txt similarity index 100% rename from doc/src/fix_rigid_meso.txt rename to doc/txt/fix_rigid_meso.txt diff --git a/doc/src/fix_rx.txt b/doc/txt/fix_rx.txt similarity index 100% rename from doc/src/fix_rx.txt rename to doc/txt/fix_rx.txt diff --git a/doc/src/fix_saed_vtk.txt b/doc/txt/fix_saed_vtk.txt similarity index 100% rename from doc/src/fix_saed_vtk.txt rename to doc/txt/fix_saed_vtk.txt diff --git a/doc/src/fix_setforce.txt b/doc/txt/fix_setforce.txt similarity index 100% rename from doc/src/fix_setforce.txt rename to doc/txt/fix_setforce.txt diff --git a/doc/src/fix_shake.txt b/doc/txt/fix_shake.txt similarity index 100% rename from doc/src/fix_shake.txt rename to doc/txt/fix_shake.txt diff --git a/doc/src/fix_shardlow.txt b/doc/txt/fix_shardlow.txt similarity index 100% rename from doc/src/fix_shardlow.txt rename to doc/txt/fix_shardlow.txt diff --git a/doc/src/fix_smd.txt b/doc/txt/fix_smd.txt similarity index 100% rename from doc/src/fix_smd.txt rename to doc/txt/fix_smd.txt diff --git a/doc/src/fix_smd_adjust_dt.txt b/doc/txt/fix_smd_adjust_dt.txt similarity index 100% rename from doc/src/fix_smd_adjust_dt.txt rename to doc/txt/fix_smd_adjust_dt.txt diff --git a/doc/src/fix_smd_integrate_tlsph.txt b/doc/txt/fix_smd_integrate_tlsph.txt similarity index 100% rename from doc/src/fix_smd_integrate_tlsph.txt rename to doc/txt/fix_smd_integrate_tlsph.txt diff --git a/doc/src/fix_smd_integrate_ulsph.txt b/doc/txt/fix_smd_integrate_ulsph.txt similarity index 100% rename from doc/src/fix_smd_integrate_ulsph.txt rename to doc/txt/fix_smd_integrate_ulsph.txt diff --git a/doc/src/fix_smd_move_triangulated_surface.txt b/doc/txt/fix_smd_move_triangulated_surface.txt similarity index 100% rename from doc/src/fix_smd_move_triangulated_surface.txt rename to doc/txt/fix_smd_move_triangulated_surface.txt diff --git a/doc/src/fix_smd_setvel.txt b/doc/txt/fix_smd_setvel.txt similarity index 100% rename from doc/src/fix_smd_setvel.txt rename to doc/txt/fix_smd_setvel.txt diff --git a/doc/src/fix_smd_wall_surface.txt b/doc/txt/fix_smd_wall_surface.txt similarity index 100% rename from doc/src/fix_smd_wall_surface.txt rename to doc/txt/fix_smd_wall_surface.txt diff --git a/doc/src/fix_spring.txt b/doc/txt/fix_spring.txt similarity index 100% rename from doc/src/fix_spring.txt rename to doc/txt/fix_spring.txt diff --git a/doc/src/fix_spring_chunk.txt b/doc/txt/fix_spring_chunk.txt similarity index 100% rename from doc/src/fix_spring_chunk.txt rename to doc/txt/fix_spring_chunk.txt diff --git a/doc/src/fix_spring_rg.txt b/doc/txt/fix_spring_rg.txt similarity index 100% rename from doc/src/fix_spring_rg.txt rename to doc/txt/fix_spring_rg.txt diff --git a/doc/src/fix_spring_self.txt b/doc/txt/fix_spring_self.txt similarity index 100% rename from doc/src/fix_spring_self.txt rename to doc/txt/fix_spring_self.txt diff --git a/doc/src/fix_srd.txt b/doc/txt/fix_srd.txt similarity index 100% rename from doc/src/fix_srd.txt rename to doc/txt/fix_srd.txt diff --git a/doc/src/fix_store_force.txt b/doc/txt/fix_store_force.txt similarity index 100% rename from doc/src/fix_store_force.txt rename to doc/txt/fix_store_force.txt diff --git a/doc/src/fix_store_state.txt b/doc/txt/fix_store_state.txt similarity index 100% rename from doc/src/fix_store_state.txt rename to doc/txt/fix_store_state.txt diff --git a/doc/src/fix_temp_berendsen.txt b/doc/txt/fix_temp_berendsen.txt similarity index 100% rename from doc/src/fix_temp_berendsen.txt rename to doc/txt/fix_temp_berendsen.txt diff --git a/doc/src/fix_temp_csvr.txt b/doc/txt/fix_temp_csvr.txt similarity index 100% rename from doc/src/fix_temp_csvr.txt rename to doc/txt/fix_temp_csvr.txt diff --git a/doc/src/fix_temp_rescale.txt b/doc/txt/fix_temp_rescale.txt similarity index 100% rename from doc/src/fix_temp_rescale.txt rename to doc/txt/fix_temp_rescale.txt diff --git a/doc/src/fix_temp_rescale_eff.txt b/doc/txt/fix_temp_rescale_eff.txt similarity index 100% rename from doc/src/fix_temp_rescale_eff.txt rename to doc/txt/fix_temp_rescale_eff.txt diff --git a/doc/src/fix_tfmc.txt b/doc/txt/fix_tfmc.txt similarity index 100% rename from doc/src/fix_tfmc.txt rename to doc/txt/fix_tfmc.txt diff --git a/doc/src/fix_thermal_conductivity.txt b/doc/txt/fix_thermal_conductivity.txt similarity index 100% rename from doc/src/fix_thermal_conductivity.txt rename to doc/txt/fix_thermal_conductivity.txt diff --git a/doc/src/fix_ti_spring.txt b/doc/txt/fix_ti_spring.txt similarity index 100% rename from doc/src/fix_ti_spring.txt rename to doc/txt/fix_ti_spring.txt diff --git a/doc/src/fix_tmd.txt b/doc/txt/fix_tmd.txt similarity index 100% rename from doc/src/fix_tmd.txt rename to doc/txt/fix_tmd.txt diff --git a/doc/src/fix_ttm.txt b/doc/txt/fix_ttm.txt similarity index 100% rename from doc/src/fix_ttm.txt rename to doc/txt/fix_ttm.txt diff --git a/doc/src/fix_tune_kspace.txt b/doc/txt/fix_tune_kspace.txt similarity index 100% rename from doc/src/fix_tune_kspace.txt rename to doc/txt/fix_tune_kspace.txt diff --git a/doc/src/fix_vector.txt b/doc/txt/fix_vector.txt similarity index 100% rename from doc/src/fix_vector.txt rename to doc/txt/fix_vector.txt diff --git a/doc/src/fix_viscosity.txt b/doc/txt/fix_viscosity.txt similarity index 100% rename from doc/src/fix_viscosity.txt rename to doc/txt/fix_viscosity.txt diff --git a/doc/src/fix_viscous.txt b/doc/txt/fix_viscous.txt similarity index 100% rename from doc/src/fix_viscous.txt rename to doc/txt/fix_viscous.txt diff --git a/doc/src/fix_wall.txt b/doc/txt/fix_wall.txt similarity index 100% rename from doc/src/fix_wall.txt rename to doc/txt/fix_wall.txt diff --git a/doc/src/fix_wall_body_polygon.txt b/doc/txt/fix_wall_body_polygon.txt similarity index 100% rename from doc/src/fix_wall_body_polygon.txt rename to doc/txt/fix_wall_body_polygon.txt diff --git a/doc/src/fix_wall_body_polyhedron.txt b/doc/txt/fix_wall_body_polyhedron.txt similarity index 100% rename from doc/src/fix_wall_body_polyhedron.txt rename to doc/txt/fix_wall_body_polyhedron.txt diff --git a/doc/src/fix_wall_ees.txt b/doc/txt/fix_wall_ees.txt similarity index 100% rename from doc/src/fix_wall_ees.txt rename to doc/txt/fix_wall_ees.txt diff --git a/doc/src/fix_wall_gran.txt b/doc/txt/fix_wall_gran.txt similarity index 100% rename from doc/src/fix_wall_gran.txt rename to doc/txt/fix_wall_gran.txt diff --git a/doc/src/fix_wall_gran_region.txt b/doc/txt/fix_wall_gran_region.txt similarity index 100% rename from doc/src/fix_wall_gran_region.txt rename to doc/txt/fix_wall_gran_region.txt diff --git a/doc/src/fix_wall_piston.txt b/doc/txt/fix_wall_piston.txt similarity index 100% rename from doc/src/fix_wall_piston.txt rename to doc/txt/fix_wall_piston.txt diff --git a/doc/src/fix_wall_reflect.txt b/doc/txt/fix_wall_reflect.txt similarity index 100% rename from doc/src/fix_wall_reflect.txt rename to doc/txt/fix_wall_reflect.txt diff --git a/doc/src/fix_wall_region.txt b/doc/txt/fix_wall_region.txt similarity index 100% rename from doc/src/fix_wall_region.txt rename to doc/txt/fix_wall_region.txt diff --git a/doc/src/fix_wall_srd.txt b/doc/txt/fix_wall_srd.txt similarity index 100% rename from doc/src/fix_wall_srd.txt rename to doc/txt/fix_wall_srd.txt diff --git a/doc/src/fixes.txt b/doc/txt/fixes.txt similarity index 100% rename from doc/src/fixes.txt rename to doc/txt/fixes.txt diff --git a/doc/src/group.txt b/doc/txt/group.txt similarity index 100% rename from doc/src/group.txt rename to doc/txt/group.txt diff --git a/doc/src/group2ndx.txt b/doc/txt/group2ndx.txt similarity index 100% rename from doc/src/group2ndx.txt rename to doc/txt/group2ndx.txt diff --git a/doc/src/hyper.txt b/doc/txt/hyper.txt similarity index 100% rename from doc/src/hyper.txt rename to doc/txt/hyper.txt diff --git a/doc/src/if.txt b/doc/txt/if.txt similarity index 100% rename from doc/src/if.txt rename to doc/txt/if.txt diff --git a/doc/src/improper_class2.txt b/doc/txt/improper_class2.txt similarity index 100% rename from doc/src/improper_class2.txt rename to doc/txt/improper_class2.txt diff --git a/doc/src/improper_coeff.txt b/doc/txt/improper_coeff.txt similarity index 100% rename from doc/src/improper_coeff.txt rename to doc/txt/improper_coeff.txt diff --git a/doc/src/improper_cossq.txt b/doc/txt/improper_cossq.txt similarity index 100% rename from doc/src/improper_cossq.txt rename to doc/txt/improper_cossq.txt diff --git a/doc/src/improper_cvff.txt b/doc/txt/improper_cvff.txt similarity index 100% rename from doc/src/improper_cvff.txt rename to doc/txt/improper_cvff.txt diff --git a/doc/src/improper_distance.txt b/doc/txt/improper_distance.txt similarity index 100% rename from doc/src/improper_distance.txt rename to doc/txt/improper_distance.txt diff --git a/doc/src/improper_distharm.txt b/doc/txt/improper_distharm.txt similarity index 100% rename from doc/src/improper_distharm.txt rename to doc/txt/improper_distharm.txt diff --git a/doc/src/improper_fourier.txt b/doc/txt/improper_fourier.txt similarity index 100% rename from doc/src/improper_fourier.txt rename to doc/txt/improper_fourier.txt diff --git a/doc/src/improper_harmonic.txt b/doc/txt/improper_harmonic.txt similarity index 100% rename from doc/src/improper_harmonic.txt rename to doc/txt/improper_harmonic.txt diff --git a/doc/src/improper_hybrid.txt b/doc/txt/improper_hybrid.txt similarity index 100% rename from doc/src/improper_hybrid.txt rename to doc/txt/improper_hybrid.txt diff --git a/doc/src/improper_inversion_harmonic.txt b/doc/txt/improper_inversion_harmonic.txt similarity index 100% rename from doc/src/improper_inversion_harmonic.txt rename to doc/txt/improper_inversion_harmonic.txt diff --git a/doc/src/improper_none.txt b/doc/txt/improper_none.txt similarity index 100% rename from doc/src/improper_none.txt rename to doc/txt/improper_none.txt diff --git a/doc/src/improper_ring.txt b/doc/txt/improper_ring.txt similarity index 100% rename from doc/src/improper_ring.txt rename to doc/txt/improper_ring.txt diff --git a/doc/src/improper_sqdistharm.txt b/doc/txt/improper_sqdistharm.txt similarity index 100% rename from doc/src/improper_sqdistharm.txt rename to doc/txt/improper_sqdistharm.txt diff --git a/doc/src/improper_style.txt b/doc/txt/improper_style.txt similarity index 100% rename from doc/src/improper_style.txt rename to doc/txt/improper_style.txt diff --git a/doc/src/improper_umbrella.txt b/doc/txt/improper_umbrella.txt similarity index 100% rename from doc/src/improper_umbrella.txt rename to doc/txt/improper_umbrella.txt diff --git a/doc/src/improper_zero.txt b/doc/txt/improper_zero.txt similarity index 100% rename from doc/src/improper_zero.txt rename to doc/txt/improper_zero.txt diff --git a/doc/src/impropers.txt b/doc/txt/impropers.txt similarity index 100% rename from doc/src/impropers.txt rename to doc/txt/impropers.txt diff --git a/doc/src/include.txt b/doc/txt/include.txt similarity index 100% rename from doc/src/include.txt rename to doc/txt/include.txt diff --git a/doc/src/info.txt b/doc/txt/info.txt similarity index 100% rename from doc/src/info.txt rename to doc/txt/info.txt diff --git a/doc/src/jump.txt b/doc/txt/jump.txt similarity index 100% rename from doc/src/jump.txt rename to doc/txt/jump.txt diff --git a/doc/src/kim_commands.txt b/doc/txt/kim_commands.txt similarity index 100% rename from doc/src/kim_commands.txt rename to doc/txt/kim_commands.txt diff --git a/doc/src/kspace_modify.txt b/doc/txt/kspace_modify.txt similarity index 100% rename from doc/src/kspace_modify.txt rename to doc/txt/kspace_modify.txt diff --git a/doc/src/kspace_style.txt b/doc/txt/kspace_style.txt similarity index 100% rename from doc/src/kspace_style.txt rename to doc/txt/kspace_style.txt diff --git a/doc/src/label.txt b/doc/txt/label.txt similarity index 100% rename from doc/src/label.txt rename to doc/txt/label.txt diff --git a/doc/src/lammps.book b/doc/txt/lammps.book similarity index 100% rename from doc/src/lammps.book rename to doc/txt/lammps.book diff --git a/doc/src/lammps_commands.txt b/doc/txt/lammps_commands.txt similarity index 100% rename from doc/src/lammps_commands.txt rename to doc/txt/lammps_commands.txt diff --git a/doc/src/lammps_commands_angle.txt b/doc/txt/lammps_commands_angle.txt similarity index 100% rename from doc/src/lammps_commands_angle.txt rename to doc/txt/lammps_commands_angle.txt diff --git a/doc/src/lammps_commands_atc.txt b/doc/txt/lammps_commands_atc.txt similarity index 100% rename from doc/src/lammps_commands_atc.txt rename to doc/txt/lammps_commands_atc.txt diff --git a/doc/src/lammps_commands_bond.txt b/doc/txt/lammps_commands_bond.txt similarity index 100% rename from doc/src/lammps_commands_bond.txt rename to doc/txt/lammps_commands_bond.txt diff --git a/doc/src/lammps_commands_compute.txt b/doc/txt/lammps_commands_compute.txt similarity index 100% rename from doc/src/lammps_commands_compute.txt rename to doc/txt/lammps_commands_compute.txt diff --git a/doc/src/lammps_commands_dihedral.txt b/doc/txt/lammps_commands_dihedral.txt similarity index 100% rename from doc/src/lammps_commands_dihedral.txt rename to doc/txt/lammps_commands_dihedral.txt diff --git a/doc/src/lammps_commands_fix.txt b/doc/txt/lammps_commands_fix.txt similarity index 100% rename from doc/src/lammps_commands_fix.txt rename to doc/txt/lammps_commands_fix.txt diff --git a/doc/src/lammps_commands_improper.txt b/doc/txt/lammps_commands_improper.txt similarity index 100% rename from doc/src/lammps_commands_improper.txt rename to doc/txt/lammps_commands_improper.txt diff --git a/doc/src/lammps_commands_kspace.txt b/doc/txt/lammps_commands_kspace.txt similarity index 100% rename from doc/src/lammps_commands_kspace.txt rename to doc/txt/lammps_commands_kspace.txt diff --git a/doc/src/lammps_commands_pair.txt b/doc/txt/lammps_commands_pair.txt similarity index 100% rename from doc/src/lammps_commands_pair.txt rename to doc/txt/lammps_commands_pair.txt diff --git a/doc/src/lattice.txt b/doc/txt/lattice.txt similarity index 100% rename from doc/src/lattice.txt rename to doc/txt/lattice.txt diff --git a/doc/src/log.txt b/doc/txt/log.txt similarity index 100% rename from doc/src/log.txt rename to doc/txt/log.txt diff --git a/doc/src/mass.txt b/doc/txt/mass.txt similarity index 100% rename from doc/src/mass.txt rename to doc/txt/mass.txt diff --git a/doc/src/message.txt b/doc/txt/message.txt similarity index 100% rename from doc/src/message.txt rename to doc/txt/message.txt diff --git a/doc/src/min_modify.txt b/doc/txt/min_modify.txt similarity index 100% rename from doc/src/min_modify.txt rename to doc/txt/min_modify.txt diff --git a/doc/src/min_spin.txt b/doc/txt/min_spin.txt similarity index 100% rename from doc/src/min_spin.txt rename to doc/txt/min_spin.txt diff --git a/doc/src/min_style.txt b/doc/txt/min_style.txt similarity index 100% rename from doc/src/min_style.txt rename to doc/txt/min_style.txt diff --git a/doc/src/minimize.txt b/doc/txt/minimize.txt similarity index 100% rename from doc/src/minimize.txt rename to doc/txt/minimize.txt diff --git a/doc/src/molecule.txt b/doc/txt/molecule.txt similarity index 100% rename from doc/src/molecule.txt rename to doc/txt/molecule.txt diff --git a/doc/src/neb.txt b/doc/txt/neb.txt similarity index 100% rename from doc/src/neb.txt rename to doc/txt/neb.txt diff --git a/doc/src/neb_spin.txt b/doc/txt/neb_spin.txt similarity index 100% rename from doc/src/neb_spin.txt rename to doc/txt/neb_spin.txt diff --git a/doc/src/neigh_modify.txt b/doc/txt/neigh_modify.txt similarity index 100% rename from doc/src/neigh_modify.txt rename to doc/txt/neigh_modify.txt diff --git a/doc/src/neighbor.txt b/doc/txt/neighbor.txt similarity index 100% rename from doc/src/neighbor.txt rename to doc/txt/neighbor.txt diff --git a/doc/src/newton.txt b/doc/txt/newton.txt similarity index 100% rename from doc/src/newton.txt rename to doc/txt/newton.txt diff --git a/doc/src/next.txt b/doc/txt/next.txt similarity index 100% rename from doc/src/next.txt rename to doc/txt/next.txt diff --git a/doc/src/package.txt b/doc/txt/package.txt similarity index 100% rename from doc/src/package.txt rename to doc/txt/package.txt diff --git a/doc/src/pair_adp.txt b/doc/txt/pair_adp.txt similarity index 100% rename from doc/src/pair_adp.txt rename to doc/txt/pair_adp.txt diff --git a/doc/src/pair_agni.txt b/doc/txt/pair_agni.txt similarity index 100% rename from doc/src/pair_agni.txt rename to doc/txt/pair_agni.txt diff --git a/doc/src/pair_airebo.txt b/doc/txt/pair_airebo.txt similarity index 100% rename from doc/src/pair_airebo.txt rename to doc/txt/pair_airebo.txt diff --git a/doc/src/pair_atm.txt b/doc/txt/pair_atm.txt similarity index 100% rename from doc/src/pair_atm.txt rename to doc/txt/pair_atm.txt diff --git a/doc/src/pair_awpmd.txt b/doc/txt/pair_awpmd.txt similarity index 100% rename from doc/src/pair_awpmd.txt rename to doc/txt/pair_awpmd.txt diff --git a/doc/src/pair_beck.txt b/doc/txt/pair_beck.txt similarity index 100% rename from doc/src/pair_beck.txt rename to doc/txt/pair_beck.txt diff --git a/doc/src/pair_body_nparticle.txt b/doc/txt/pair_body_nparticle.txt similarity index 100% rename from doc/src/pair_body_nparticle.txt rename to doc/txt/pair_body_nparticle.txt diff --git a/doc/src/pair_body_rounded_polygon.txt b/doc/txt/pair_body_rounded_polygon.txt similarity index 100% rename from doc/src/pair_body_rounded_polygon.txt rename to doc/txt/pair_body_rounded_polygon.txt diff --git a/doc/src/pair_body_rounded_polyhedron.txt b/doc/txt/pair_body_rounded_polyhedron.txt similarity index 100% rename from doc/src/pair_body_rounded_polyhedron.txt rename to doc/txt/pair_body_rounded_polyhedron.txt diff --git a/doc/src/pair_bop.txt b/doc/txt/pair_bop.txt similarity index 100% rename from doc/src/pair_bop.txt rename to doc/txt/pair_bop.txt diff --git a/doc/src/pair_born.txt b/doc/txt/pair_born.txt similarity index 100% rename from doc/src/pair_born.txt rename to doc/txt/pair_born.txt diff --git a/doc/src/pair_brownian.txt b/doc/txt/pair_brownian.txt similarity index 100% rename from doc/src/pair_brownian.txt rename to doc/txt/pair_brownian.txt diff --git a/doc/src/pair_buck.txt b/doc/txt/pair_buck.txt similarity index 100% rename from doc/src/pair_buck.txt rename to doc/txt/pair_buck.txt diff --git a/doc/src/pair_buck6d_coul_gauss.txt b/doc/txt/pair_buck6d_coul_gauss.txt similarity index 100% rename from doc/src/pair_buck6d_coul_gauss.txt rename to doc/txt/pair_buck6d_coul_gauss.txt diff --git a/doc/src/pair_buck_long.txt b/doc/txt/pair_buck_long.txt similarity index 100% rename from doc/src/pair_buck_long.txt rename to doc/txt/pair_buck_long.txt diff --git a/doc/src/pair_charmm.txt b/doc/txt/pair_charmm.txt similarity index 100% rename from doc/src/pair_charmm.txt rename to doc/txt/pair_charmm.txt diff --git a/doc/src/pair_class2.txt b/doc/txt/pair_class2.txt similarity index 100% rename from doc/src/pair_class2.txt rename to doc/txt/pair_class2.txt diff --git a/doc/src/pair_coeff.txt b/doc/txt/pair_coeff.txt similarity index 100% rename from doc/src/pair_coeff.txt rename to doc/txt/pair_coeff.txt diff --git a/doc/src/pair_colloid.txt b/doc/txt/pair_colloid.txt similarity index 100% rename from doc/src/pair_colloid.txt rename to doc/txt/pair_colloid.txt diff --git a/doc/src/pair_comb.txt b/doc/txt/pair_comb.txt similarity index 100% rename from doc/src/pair_comb.txt rename to doc/txt/pair_comb.txt diff --git a/doc/src/pair_cosine_squared.txt b/doc/txt/pair_cosine_squared.txt similarity index 100% rename from doc/src/pair_cosine_squared.txt rename to doc/txt/pair_cosine_squared.txt diff --git a/doc/src/pair_coul.txt b/doc/txt/pair_coul.txt similarity index 100% rename from doc/src/pair_coul.txt rename to doc/txt/pair_coul.txt diff --git a/doc/src/pair_coul_diel.txt b/doc/txt/pair_coul_diel.txt similarity index 100% rename from doc/src/pair_coul_diel.txt rename to doc/txt/pair_coul_diel.txt diff --git a/doc/src/pair_coul_shield.txt b/doc/txt/pair_coul_shield.txt similarity index 100% rename from doc/src/pair_coul_shield.txt rename to doc/txt/pair_coul_shield.txt diff --git a/doc/src/pair_cs.txt b/doc/txt/pair_cs.txt similarity index 100% rename from doc/src/pair_cs.txt rename to doc/txt/pair_cs.txt diff --git a/doc/src/pair_dipole.txt b/doc/txt/pair_dipole.txt similarity index 100% rename from doc/src/pair_dipole.txt rename to doc/txt/pair_dipole.txt diff --git a/doc/src/pair_dpd.txt b/doc/txt/pair_dpd.txt similarity index 100% rename from doc/src/pair_dpd.txt rename to doc/txt/pair_dpd.txt diff --git a/doc/src/pair_dpd_fdt.txt b/doc/txt/pair_dpd_fdt.txt similarity index 100% rename from doc/src/pair_dpd_fdt.txt rename to doc/txt/pair_dpd_fdt.txt diff --git a/doc/src/pair_drip.txt b/doc/txt/pair_drip.txt similarity index 100% rename from doc/src/pair_drip.txt rename to doc/txt/pair_drip.txt diff --git a/doc/src/pair_dsmc.txt b/doc/txt/pair_dsmc.txt similarity index 100% rename from doc/src/pair_dsmc.txt rename to doc/txt/pair_dsmc.txt diff --git a/doc/src/pair_e3b.txt b/doc/txt/pair_e3b.txt similarity index 100% rename from doc/src/pair_e3b.txt rename to doc/txt/pair_e3b.txt diff --git a/doc/src/pair_eam.txt b/doc/txt/pair_eam.txt similarity index 100% rename from doc/src/pair_eam.txt rename to doc/txt/pair_eam.txt diff --git a/doc/src/pair_edip.txt b/doc/txt/pair_edip.txt similarity index 100% rename from doc/src/pair_edip.txt rename to doc/txt/pair_edip.txt diff --git a/doc/src/pair_eff.txt b/doc/txt/pair_eff.txt similarity index 100% rename from doc/src/pair_eff.txt rename to doc/txt/pair_eff.txt diff --git a/doc/src/pair_eim.txt b/doc/txt/pair_eim.txt similarity index 100% rename from doc/src/pair_eim.txt rename to doc/txt/pair_eim.txt diff --git a/doc/src/pair_exp6_rx.txt b/doc/txt/pair_exp6_rx.txt similarity index 100% rename from doc/src/pair_exp6_rx.txt rename to doc/txt/pair_exp6_rx.txt diff --git a/doc/src/pair_extep.txt b/doc/txt/pair_extep.txt similarity index 100% rename from doc/src/pair_extep.txt rename to doc/txt/pair_extep.txt diff --git a/doc/src/pair_fep_soft.txt b/doc/txt/pair_fep_soft.txt similarity index 100% rename from doc/src/pair_fep_soft.txt rename to doc/txt/pair_fep_soft.txt diff --git a/doc/src/pair_gauss.txt b/doc/txt/pair_gauss.txt similarity index 100% rename from doc/src/pair_gauss.txt rename to doc/txt/pair_gauss.txt diff --git a/doc/src/pair_gayberne.txt b/doc/txt/pair_gayberne.txt similarity index 100% rename from doc/src/pair_gayberne.txt rename to doc/txt/pair_gayberne.txt diff --git a/doc/src/pair_gran.txt b/doc/txt/pair_gran.txt similarity index 100% rename from doc/src/pair_gran.txt rename to doc/txt/pair_gran.txt diff --git a/doc/src/pair_granular.txt b/doc/txt/pair_granular.txt similarity index 100% rename from doc/src/pair_granular.txt rename to doc/txt/pair_granular.txt diff --git a/doc/src/pair_gromacs.txt b/doc/txt/pair_gromacs.txt similarity index 100% rename from doc/src/pair_gromacs.txt rename to doc/txt/pair_gromacs.txt diff --git a/doc/src/pair_gw.txt b/doc/txt/pair_gw.txt similarity index 100% rename from doc/src/pair_gw.txt rename to doc/txt/pair_gw.txt diff --git a/doc/src/pair_hbond_dreiding.txt b/doc/txt/pair_hbond_dreiding.txt similarity index 100% rename from doc/src/pair_hbond_dreiding.txt rename to doc/txt/pair_hbond_dreiding.txt diff --git a/doc/src/pair_hybrid.txt b/doc/txt/pair_hybrid.txt similarity index 100% rename from doc/src/pair_hybrid.txt rename to doc/txt/pair_hybrid.txt diff --git a/doc/src/pair_ilp_graphene_hbn.txt b/doc/txt/pair_ilp_graphene_hbn.txt similarity index 100% rename from doc/src/pair_ilp_graphene_hbn.txt rename to doc/txt/pair_ilp_graphene_hbn.txt diff --git a/doc/src/pair_kim.txt b/doc/txt/pair_kim.txt similarity index 100% rename from doc/src/pair_kim.txt rename to doc/txt/pair_kim.txt diff --git a/doc/src/pair_kolmogorov_crespi_full.txt b/doc/txt/pair_kolmogorov_crespi_full.txt similarity index 100% rename from doc/src/pair_kolmogorov_crespi_full.txt rename to doc/txt/pair_kolmogorov_crespi_full.txt diff --git a/doc/src/pair_kolmogorov_crespi_z.txt b/doc/txt/pair_kolmogorov_crespi_z.txt similarity index 100% rename from doc/src/pair_kolmogorov_crespi_z.txt rename to doc/txt/pair_kolmogorov_crespi_z.txt diff --git a/doc/src/pair_lcbop.txt b/doc/txt/pair_lcbop.txt similarity index 100% rename from doc/src/pair_lcbop.txt rename to doc/txt/pair_lcbop.txt diff --git a/doc/src/pair_lebedeva_z.txt b/doc/txt/pair_lebedeva_z.txt similarity index 100% rename from doc/src/pair_lebedeva_z.txt rename to doc/txt/pair_lebedeva_z.txt diff --git a/doc/src/pair_line_lj.txt b/doc/txt/pair_line_lj.txt similarity index 100% rename from doc/src/pair_line_lj.txt rename to doc/txt/pair_line_lj.txt diff --git a/doc/src/pair_list.txt b/doc/txt/pair_list.txt similarity index 100% rename from doc/src/pair_list.txt rename to doc/txt/pair_list.txt diff --git a/doc/src/pair_lj.txt b/doc/txt/pair_lj.txt similarity index 100% rename from doc/src/pair_lj.txt rename to doc/txt/pair_lj.txt diff --git a/doc/src/pair_lj96.txt b/doc/txt/pair_lj96.txt similarity index 100% rename from doc/src/pair_lj96.txt rename to doc/txt/pair_lj96.txt diff --git a/doc/src/pair_lj_cubic.txt b/doc/txt/pair_lj_cubic.txt similarity index 100% rename from doc/src/pair_lj_cubic.txt rename to doc/txt/pair_lj_cubic.txt diff --git a/doc/src/pair_lj_expand.txt b/doc/txt/pair_lj_expand.txt similarity index 100% rename from doc/src/pair_lj_expand.txt rename to doc/txt/pair_lj_expand.txt diff --git a/doc/src/pair_lj_long.txt b/doc/txt/pair_lj_long.txt similarity index 100% rename from doc/src/pair_lj_long.txt rename to doc/txt/pair_lj_long.txt diff --git a/doc/src/pair_lj_smooth.txt b/doc/txt/pair_lj_smooth.txt similarity index 100% rename from doc/src/pair_lj_smooth.txt rename to doc/txt/pair_lj_smooth.txt diff --git a/doc/src/pair_lj_smooth_linear.txt b/doc/txt/pair_lj_smooth_linear.txt similarity index 100% rename from doc/src/pair_lj_smooth_linear.txt rename to doc/txt/pair_lj_smooth_linear.txt diff --git a/doc/src/pair_lj_switch3_coulgauss.txt b/doc/txt/pair_lj_switch3_coulgauss.txt similarity index 100% rename from doc/src/pair_lj_switch3_coulgauss.txt rename to doc/txt/pair_lj_switch3_coulgauss.txt diff --git a/doc/src/pair_local_density.txt b/doc/txt/pair_local_density.txt similarity index 100% rename from doc/src/pair_local_density.txt rename to doc/txt/pair_local_density.txt diff --git a/doc/src/pair_lubricate.txt b/doc/txt/pair_lubricate.txt similarity index 100% rename from doc/src/pair_lubricate.txt rename to doc/txt/pair_lubricate.txt diff --git a/doc/src/pair_lubricateU.txt b/doc/txt/pair_lubricateU.txt similarity index 100% rename from doc/src/pair_lubricateU.txt rename to doc/txt/pair_lubricateU.txt diff --git a/doc/src/pair_mdf.txt b/doc/txt/pair_mdf.txt similarity index 100% rename from doc/src/pair_mdf.txt rename to doc/txt/pair_mdf.txt diff --git a/doc/src/pair_meam_spline.txt b/doc/txt/pair_meam_spline.txt similarity index 100% rename from doc/src/pair_meam_spline.txt rename to doc/txt/pair_meam_spline.txt diff --git a/doc/src/pair_meam_sw_spline.txt b/doc/txt/pair_meam_sw_spline.txt similarity index 100% rename from doc/src/pair_meam_sw_spline.txt rename to doc/txt/pair_meam_sw_spline.txt diff --git a/doc/src/pair_meamc.txt b/doc/txt/pair_meamc.txt similarity index 100% rename from doc/src/pair_meamc.txt rename to doc/txt/pair_meamc.txt diff --git a/doc/src/pair_meso.txt b/doc/txt/pair_meso.txt similarity index 100% rename from doc/src/pair_meso.txt rename to doc/txt/pair_meso.txt diff --git a/doc/src/pair_mgpt.txt b/doc/txt/pair_mgpt.txt similarity index 100% rename from doc/src/pair_mgpt.txt rename to doc/txt/pair_mgpt.txt diff --git a/doc/src/pair_mie.txt b/doc/txt/pair_mie.txt similarity index 100% rename from doc/src/pair_mie.txt rename to doc/txt/pair_mie.txt diff --git a/doc/src/pair_mm3_switch3_coulgauss.txt b/doc/txt/pair_mm3_switch3_coulgauss.txt similarity index 100% rename from doc/src/pair_mm3_switch3_coulgauss.txt rename to doc/txt/pair_mm3_switch3_coulgauss.txt diff --git a/doc/src/pair_modify.txt b/doc/txt/pair_modify.txt similarity index 100% rename from doc/src/pair_modify.txt rename to doc/txt/pair_modify.txt diff --git a/doc/src/pair_momb.txt b/doc/txt/pair_momb.txt similarity index 100% rename from doc/src/pair_momb.txt rename to doc/txt/pair_momb.txt diff --git a/doc/src/pair_morse.txt b/doc/txt/pair_morse.txt similarity index 100% rename from doc/src/pair_morse.txt rename to doc/txt/pair_morse.txt diff --git a/doc/src/pair_multi_lucy.txt b/doc/txt/pair_multi_lucy.txt similarity index 100% rename from doc/src/pair_multi_lucy.txt rename to doc/txt/pair_multi_lucy.txt diff --git a/doc/src/pair_multi_lucy_rx.txt b/doc/txt/pair_multi_lucy_rx.txt similarity index 100% rename from doc/src/pair_multi_lucy_rx.txt rename to doc/txt/pair_multi_lucy_rx.txt diff --git a/doc/src/pair_nb3b_harmonic.txt b/doc/txt/pair_nb3b_harmonic.txt similarity index 100% rename from doc/src/pair_nb3b_harmonic.txt rename to doc/txt/pair_nb3b_harmonic.txt diff --git a/doc/src/pair_nm.txt b/doc/txt/pair_nm.txt similarity index 100% rename from doc/src/pair_nm.txt rename to doc/txt/pair_nm.txt diff --git a/doc/src/pair_none.txt b/doc/txt/pair_none.txt similarity index 100% rename from doc/src/pair_none.txt rename to doc/txt/pair_none.txt diff --git a/doc/src/pair_oxdna.txt b/doc/txt/pair_oxdna.txt similarity index 100% rename from doc/src/pair_oxdna.txt rename to doc/txt/pair_oxdna.txt diff --git a/doc/src/pair_oxdna2.txt b/doc/txt/pair_oxdna2.txt similarity index 100% rename from doc/src/pair_oxdna2.txt rename to doc/txt/pair_oxdna2.txt diff --git a/doc/src/pair_peri.txt b/doc/txt/pair_peri.txt similarity index 100% rename from doc/src/pair_peri.txt rename to doc/txt/pair_peri.txt diff --git a/doc/src/pair_polymorphic.txt b/doc/txt/pair_polymorphic.txt similarity index 100% rename from doc/src/pair_polymorphic.txt rename to doc/txt/pair_polymorphic.txt diff --git a/doc/src/pair_python.txt b/doc/txt/pair_python.txt similarity index 100% rename from doc/src/pair_python.txt rename to doc/txt/pair_python.txt diff --git a/doc/src/pair_quip.txt b/doc/txt/pair_quip.txt similarity index 100% rename from doc/src/pair_quip.txt rename to doc/txt/pair_quip.txt diff --git a/doc/src/pair_reaxc.txt b/doc/txt/pair_reaxc.txt similarity index 100% rename from doc/src/pair_reaxc.txt rename to doc/txt/pair_reaxc.txt diff --git a/doc/src/pair_resquared.txt b/doc/txt/pair_resquared.txt similarity index 100% rename from doc/src/pair_resquared.txt rename to doc/txt/pair_resquared.txt diff --git a/doc/src/pair_sdk.txt b/doc/txt/pair_sdk.txt similarity index 100% rename from doc/src/pair_sdk.txt rename to doc/txt/pair_sdk.txt diff --git a/doc/src/pair_sdpd_taitwater_isothermal.txt b/doc/txt/pair_sdpd_taitwater_isothermal.txt similarity index 100% rename from doc/src/pair_sdpd_taitwater_isothermal.txt rename to doc/txt/pair_sdpd_taitwater_isothermal.txt diff --git a/doc/src/pair_smd_hertz.txt b/doc/txt/pair_smd_hertz.txt similarity index 100% rename from doc/src/pair_smd_hertz.txt rename to doc/txt/pair_smd_hertz.txt diff --git a/doc/src/pair_smd_tlsph.txt b/doc/txt/pair_smd_tlsph.txt similarity index 100% rename from doc/src/pair_smd_tlsph.txt rename to doc/txt/pair_smd_tlsph.txt diff --git a/doc/src/pair_smd_triangulated_surface.txt b/doc/txt/pair_smd_triangulated_surface.txt similarity index 100% rename from doc/src/pair_smd_triangulated_surface.txt rename to doc/txt/pair_smd_triangulated_surface.txt diff --git a/doc/src/pair_smd_ulsph.txt b/doc/txt/pair_smd_ulsph.txt similarity index 100% rename from doc/src/pair_smd_ulsph.txt rename to doc/txt/pair_smd_ulsph.txt diff --git a/doc/src/pair_smtbq.txt b/doc/txt/pair_smtbq.txt similarity index 100% rename from doc/src/pair_smtbq.txt rename to doc/txt/pair_smtbq.txt diff --git a/doc/src/pair_snap.txt b/doc/txt/pair_snap.txt similarity index 100% rename from doc/src/pair_snap.txt rename to doc/txt/pair_snap.txt diff --git a/doc/src/pair_soft.txt b/doc/txt/pair_soft.txt similarity index 100% rename from doc/src/pair_soft.txt rename to doc/txt/pair_soft.txt diff --git a/doc/src/pair_sph_heatconduction.txt b/doc/txt/pair_sph_heatconduction.txt similarity index 100% rename from doc/src/pair_sph_heatconduction.txt rename to doc/txt/pair_sph_heatconduction.txt diff --git a/doc/src/pair_sph_idealgas.txt b/doc/txt/pair_sph_idealgas.txt similarity index 100% rename from doc/src/pair_sph_idealgas.txt rename to doc/txt/pair_sph_idealgas.txt diff --git a/doc/src/pair_sph_lj.txt b/doc/txt/pair_sph_lj.txt similarity index 100% rename from doc/src/pair_sph_lj.txt rename to doc/txt/pair_sph_lj.txt diff --git a/doc/src/pair_sph_rhosum.txt b/doc/txt/pair_sph_rhosum.txt similarity index 100% rename from doc/src/pair_sph_rhosum.txt rename to doc/txt/pair_sph_rhosum.txt diff --git a/doc/src/pair_sph_taitwater.txt b/doc/txt/pair_sph_taitwater.txt similarity index 100% rename from doc/src/pair_sph_taitwater.txt rename to doc/txt/pair_sph_taitwater.txt diff --git a/doc/src/pair_sph_taitwater_morris.txt b/doc/txt/pair_sph_taitwater_morris.txt similarity index 100% rename from doc/src/pair_sph_taitwater_morris.txt rename to doc/txt/pair_sph_taitwater_morris.txt diff --git a/doc/src/pair_spin_dipole.txt b/doc/txt/pair_spin_dipole.txt similarity index 100% rename from doc/src/pair_spin_dipole.txt rename to doc/txt/pair_spin_dipole.txt diff --git a/doc/src/pair_spin_dmi.txt b/doc/txt/pair_spin_dmi.txt similarity index 100% rename from doc/src/pair_spin_dmi.txt rename to doc/txt/pair_spin_dmi.txt diff --git a/doc/src/pair_spin_exchange.txt b/doc/txt/pair_spin_exchange.txt similarity index 100% rename from doc/src/pair_spin_exchange.txt rename to doc/txt/pair_spin_exchange.txt diff --git a/doc/src/pair_spin_magelec.txt b/doc/txt/pair_spin_magelec.txt similarity index 100% rename from doc/src/pair_spin_magelec.txt rename to doc/txt/pair_spin_magelec.txt diff --git a/doc/src/pair_spin_neel.txt b/doc/txt/pair_spin_neel.txt similarity index 100% rename from doc/src/pair_spin_neel.txt rename to doc/txt/pair_spin_neel.txt diff --git a/doc/src/pair_srp.txt b/doc/txt/pair_srp.txt similarity index 100% rename from doc/src/pair_srp.txt rename to doc/txt/pair_srp.txt diff --git a/doc/src/pair_style.txt b/doc/txt/pair_style.txt similarity index 100% rename from doc/src/pair_style.txt rename to doc/txt/pair_style.txt diff --git a/doc/src/pair_sw.txt b/doc/txt/pair_sw.txt similarity index 100% rename from doc/src/pair_sw.txt rename to doc/txt/pair_sw.txt diff --git a/doc/src/pair_table.txt b/doc/txt/pair_table.txt similarity index 100% rename from doc/src/pair_table.txt rename to doc/txt/pair_table.txt diff --git a/doc/src/pair_table_rx.txt b/doc/txt/pair_table_rx.txt similarity index 100% rename from doc/src/pair_table_rx.txt rename to doc/txt/pair_table_rx.txt diff --git a/doc/src/pair_tersoff.txt b/doc/txt/pair_tersoff.txt similarity index 100% rename from doc/src/pair_tersoff.txt rename to doc/txt/pair_tersoff.txt diff --git a/doc/src/pair_tersoff_mod.txt b/doc/txt/pair_tersoff_mod.txt similarity index 100% rename from doc/src/pair_tersoff_mod.txt rename to doc/txt/pair_tersoff_mod.txt diff --git a/doc/src/pair_tersoff_zbl.txt b/doc/txt/pair_tersoff_zbl.txt similarity index 100% rename from doc/src/pair_tersoff_zbl.txt rename to doc/txt/pair_tersoff_zbl.txt diff --git a/doc/src/pair_thole.txt b/doc/txt/pair_thole.txt similarity index 100% rename from doc/src/pair_thole.txt rename to doc/txt/pair_thole.txt diff --git a/doc/src/pair_tri_lj.txt b/doc/txt/pair_tri_lj.txt similarity index 100% rename from doc/src/pair_tri_lj.txt rename to doc/txt/pair_tri_lj.txt diff --git a/doc/src/pair_ufm.txt b/doc/txt/pair_ufm.txt similarity index 100% rename from doc/src/pair_ufm.txt rename to doc/txt/pair_ufm.txt diff --git a/doc/src/pair_vashishta.txt b/doc/txt/pair_vashishta.txt similarity index 100% rename from doc/src/pair_vashishta.txt rename to doc/txt/pair_vashishta.txt diff --git a/doc/src/pair_write.txt b/doc/txt/pair_write.txt similarity index 100% rename from doc/src/pair_write.txt rename to doc/txt/pair_write.txt diff --git a/doc/src/pair_yukawa.txt b/doc/txt/pair_yukawa.txt similarity index 100% rename from doc/src/pair_yukawa.txt rename to doc/txt/pair_yukawa.txt diff --git a/doc/src/pair_yukawa_colloid.txt b/doc/txt/pair_yukawa_colloid.txt similarity index 100% rename from doc/src/pair_yukawa_colloid.txt rename to doc/txt/pair_yukawa_colloid.txt diff --git a/doc/src/pair_zbl.txt b/doc/txt/pair_zbl.txt similarity index 100% rename from doc/src/pair_zbl.txt rename to doc/txt/pair_zbl.txt diff --git a/doc/src/pair_zero.txt b/doc/txt/pair_zero.txt similarity index 100% rename from doc/src/pair_zero.txt rename to doc/txt/pair_zero.txt diff --git a/doc/src/pairs.txt b/doc/txt/pairs.txt similarity index 100% rename from doc/src/pairs.txt rename to doc/txt/pairs.txt diff --git a/doc/src/partition.txt b/doc/txt/partition.txt similarity index 100% rename from doc/src/partition.txt rename to doc/txt/partition.txt diff --git a/doc/src/prd.txt b/doc/txt/prd.txt similarity index 100% rename from doc/src/prd.txt rename to doc/txt/prd.txt diff --git a/doc/src/print.txt b/doc/txt/print.txt similarity index 100% rename from doc/src/print.txt rename to doc/txt/print.txt diff --git a/doc/src/processors.txt b/doc/txt/processors.txt similarity index 100% rename from doc/src/processors.txt rename to doc/txt/processors.txt diff --git a/doc/src/python.txt b/doc/txt/python.txt similarity index 100% rename from doc/src/python.txt rename to doc/txt/python.txt diff --git a/doc/src/quit.txt b/doc/txt/quit.txt similarity index 100% rename from doc/src/quit.txt rename to doc/txt/quit.txt diff --git a/doc/src/read_data.txt b/doc/txt/read_data.txt similarity index 100% rename from doc/src/read_data.txt rename to doc/txt/read_data.txt diff --git a/doc/src/read_dump.txt b/doc/txt/read_dump.txt similarity index 100% rename from doc/src/read_dump.txt rename to doc/txt/read_dump.txt diff --git a/doc/src/read_restart.txt b/doc/txt/read_restart.txt similarity index 100% rename from doc/src/read_restart.txt rename to doc/txt/read_restart.txt diff --git a/doc/src/region.txt b/doc/txt/region.txt similarity index 100% rename from doc/src/region.txt rename to doc/txt/region.txt diff --git a/doc/src/replicate.txt b/doc/txt/replicate.txt similarity index 100% rename from doc/src/replicate.txt rename to doc/txt/replicate.txt diff --git a/doc/src/rerun.txt b/doc/txt/rerun.txt similarity index 100% rename from doc/src/rerun.txt rename to doc/txt/rerun.txt diff --git a/doc/src/reset_ids.txt b/doc/txt/reset_ids.txt similarity index 100% rename from doc/src/reset_ids.txt rename to doc/txt/reset_ids.txt diff --git a/doc/src/reset_timestep.txt b/doc/txt/reset_timestep.txt similarity index 100% rename from doc/src/reset_timestep.txt rename to doc/txt/reset_timestep.txt diff --git a/doc/src/restart.txt b/doc/txt/restart.txt similarity index 100% rename from doc/src/restart.txt rename to doc/txt/restart.txt diff --git a/doc/src/run.txt b/doc/txt/run.txt similarity index 100% rename from doc/src/run.txt rename to doc/txt/run.txt diff --git a/doc/src/run_style.txt b/doc/txt/run_style.txt similarity index 100% rename from doc/src/run_style.txt rename to doc/txt/run_style.txt diff --git a/doc/src/server.txt b/doc/txt/server.txt similarity index 100% rename from doc/src/server.txt rename to doc/txt/server.txt diff --git a/doc/src/server_mc.txt b/doc/txt/server_mc.txt similarity index 100% rename from doc/src/server_mc.txt rename to doc/txt/server_mc.txt diff --git a/doc/src/server_md.txt b/doc/txt/server_md.txt similarity index 100% rename from doc/src/server_md.txt rename to doc/txt/server_md.txt diff --git a/doc/src/set.txt b/doc/txt/set.txt similarity index 100% rename from doc/src/set.txt rename to doc/txt/set.txt diff --git a/doc/src/shell.txt b/doc/txt/shell.txt similarity index 100% rename from doc/src/shell.txt rename to doc/txt/shell.txt diff --git a/doc/src/special_bonds.txt b/doc/txt/special_bonds.txt similarity index 100% rename from doc/src/special_bonds.txt rename to doc/txt/special_bonds.txt diff --git a/doc/src/suffix.txt b/doc/txt/suffix.txt similarity index 100% rename from doc/src/suffix.txt rename to doc/txt/suffix.txt diff --git a/doc/src/tad.txt b/doc/txt/tad.txt similarity index 100% rename from doc/src/tad.txt rename to doc/txt/tad.txt diff --git a/doc/src/temper.txt b/doc/txt/temper.txt similarity index 100% rename from doc/src/temper.txt rename to doc/txt/temper.txt diff --git a/doc/src/temper_grem.txt b/doc/txt/temper_grem.txt similarity index 100% rename from doc/src/temper_grem.txt rename to doc/txt/temper_grem.txt diff --git a/doc/src/temper_npt.txt b/doc/txt/temper_npt.txt similarity index 100% rename from doc/src/temper_npt.txt rename to doc/txt/temper_npt.txt diff --git a/doc/src/thermo.txt b/doc/txt/thermo.txt similarity index 100% rename from doc/src/thermo.txt rename to doc/txt/thermo.txt diff --git a/doc/src/thermo_modify.txt b/doc/txt/thermo_modify.txt similarity index 100% rename from doc/src/thermo_modify.txt rename to doc/txt/thermo_modify.txt diff --git a/doc/src/thermo_style.txt b/doc/txt/thermo_style.txt similarity index 100% rename from doc/src/thermo_style.txt rename to doc/txt/thermo_style.txt diff --git a/doc/src/third_order.txt b/doc/txt/third_order.txt similarity index 100% rename from doc/src/third_order.txt rename to doc/txt/third_order.txt diff --git a/doc/src/timer.txt b/doc/txt/timer.txt similarity index 100% rename from doc/src/timer.txt rename to doc/txt/timer.txt diff --git a/doc/src/timestep.txt b/doc/txt/timestep.txt similarity index 100% rename from doc/src/timestep.txt rename to doc/txt/timestep.txt diff --git a/doc/src/uncompute.txt b/doc/txt/uncompute.txt similarity index 100% rename from doc/src/uncompute.txt rename to doc/txt/uncompute.txt diff --git a/doc/src/undump.txt b/doc/txt/undump.txt similarity index 100% rename from doc/src/undump.txt rename to doc/txt/undump.txt diff --git a/doc/src/unfix.txt b/doc/txt/unfix.txt similarity index 100% rename from doc/src/unfix.txt rename to doc/txt/unfix.txt diff --git a/doc/src/units.txt b/doc/txt/units.txt similarity index 100% rename from doc/src/units.txt rename to doc/txt/units.txt diff --git a/doc/src/variable.txt b/doc/txt/variable.txt similarity index 100% rename from doc/src/variable.txt rename to doc/txt/variable.txt diff --git a/doc/src/velocity.txt b/doc/txt/velocity.txt similarity index 100% rename from doc/src/velocity.txt rename to doc/txt/velocity.txt diff --git a/doc/src/write_coeff.txt b/doc/txt/write_coeff.txt similarity index 100% rename from doc/src/write_coeff.txt rename to doc/txt/write_coeff.txt diff --git a/doc/src/write_data.txt b/doc/txt/write_data.txt similarity index 100% rename from doc/src/write_data.txt rename to doc/txt/write_data.txt diff --git a/doc/src/write_dump.txt b/doc/txt/write_dump.txt similarity index 100% rename from doc/src/write_dump.txt rename to doc/txt/write_dump.txt diff --git a/doc/src/write_restart.txt b/doc/txt/write_restart.txt similarity index 100% rename from doc/src/write_restart.txt rename to doc/txt/write_restart.txt From 423a3bb99f9f8f294670c2f5a0f2516b3cd0c190 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 5 Nov 2019 14:22:17 -0500 Subject: [PATCH 342/557] Add initial version of updated tools from #1533 --- .../lammpsdoc/eqImg2mathjaxInline.py | 238 ++++++++++++++++++ .../converters/lammpsdoc/rst_anchor_check.py | 64 +++++ doc/utils/converters/setup.py | 2 +- 3 files changed, 303 insertions(+), 1 deletion(-) create mode 100644 doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py create mode 100644 doc/utils/converters/lammpsdoc/rst_anchor_check.py diff --git a/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py b/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py new file mode 100644 index 0000000000..6db83da7fd --- /dev/null +++ b/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py @@ -0,0 +1,238 @@ +#! /usr/bin/env python3 +# LAMMPS Documentation Utilities +# +# Scan for duplicate anchor labels in documentation files +# +# Copyright (C) 2019 E. Anne Gunn +# Based largely on doc_anchor_check.py by Richard Berger +# +# 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 3 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 . +import argparse +import os +import re +import sys + + +# We only want to replace image lines where image is +# pulled from Eqs subfolder +image_pattern = re.compile(r'.*image:: Eqs/(.*)\.jpg') +tex_eq_pattern = re.compile(r'\$\$') +latex_begin_eq_pattern = re.compile(r'\\begin{equation}') +latex_end_eq_pattern = re.compile(r'\\end{equation}') +latex_begin_eqArray_pattern = re.compile(r'\\begin{eqnarray\*}') +latex_end_eqArray_pattern = re.compile(r'\\end{eqnarray\*}') + +imageMarker = ">>>image was here" +image_marker_pattern = re.compile(r'>>>image was here') +align_pattern = re.compile(r'.*:align: center') + +modifiedFileFolder = "src/modifiedRst/" +# Since this is a proof of concept implementation, +# skip any rst files that are known to cause problems +skipFileList = ["pair_tersoff_zbl.rst"] + +runReport = { +} + + +def checkForEquationStart(texLine): + eqType = None + texMatch = tex_eq_pattern.match(texLine) + if texMatch: + eqType = "texMatch" + else: + eqMatch = latex_begin_eq_pattern.match(texLine) + if eqMatch: + eqType = "eqMatch" + else: + eqArrayMatch = latex_begin_eqArray_pattern.match(texLine) + if eqArrayMatch: + eqType = "eqArrayMatch" + return eqType + + +def checkForEquationEnd(texLine, eqType): + endPattern = tex_eq_pattern + if eqType == "texMatch": + endPattern = tex_eq_pattern + elif eqType == "eqMatch": + endPattern = latex_end_eq_pattern + elif eqType == "eqArrayMatch": + endPattern = latex_end_eqArray_pattern + else: + print("***error: unexpected eqType %s, will look for tex delimiter" % eqType) + + endMatch = endPattern.match(texLine) + endFound = endMatch is not None + if endFound: + print("found pattern end, line: %s" % texLine) + return endFound + + +def startMathjax(): + mathjaxLines = [] + mathjaxLines.append(".. math::\n\n") + return mathjaxLines + + +def endMathjax(mathjaxLines): + mathjaxLines.append("\n") + mathjaxLines.append("%s\n" % imageMarker) + return mathjaxLines + + +def processFile(filename): + print("in processFile for filename: %s" % filename) + imageCount = 0 + + modifiedFileLines = [] + doWriteModifiedFile = False + with open(filename, 'rt') as f: + for line_number, line in enumerate(f): + m = image_pattern.match(line) + if m: + fileroot = m.group(1) + print("fileroot: {0}".format(fileroot)) + imageCount += 1 + texFilename = "src/Eqs/{0}.tex".format(fileroot) + print("will try to open %s" % texFilename) + eqType = None + eqLines = [] + try: + with open(texFilename, 'rt', encoding='utf-8') as t: + print("%s file opened ok" % texFilename) + eqLines = startMathjax() + try: + for dummy, texLine in enumerate(t): + #print(texLine) + if eqType == None: + eqType = checkForEquationStart(texLine) + if eqType != None: + print("equation type: {0}".format(eqType)) + else: + endFound = checkForEquationEnd(texLine, eqType) + if endFound != True: + eqLines.append(texLine) + else: + eqType = None + eqLines = endMathjax(eqLines) + print("Equation lines will be:") + print("-----------------------------") + print(*eqLines, sep="\n") + print("-----------------------------") + except UnicodeDecodeError: + print("UnicodeDecodeError reading file file %s, image markup will be left in place" % texFilename) + break + except EnvironmentError: + error = "could not open source tex file {0}, line: {1}".format(texFilename, line) + print(error) + print("image markup will be left in place") + if filename not in runReport: + runReport[filename] = [] + runReport[filename].append(error) + # put the image line we could not replace back into the output + eqLines.append(line) + if len(eqLines) > 0: + modifiedFileLines.extend(eqLines) + doWriteModifiedFile = True + eqLines = [] + else: + # not an equation line, so simply queue it up for output as is + modifiedFileLines.append(line) + if doWriteModifiedFile: + #print(*modifiedFileLines, sep="\n") + print("modifiedFileLines has %d lines before align center cleanup" % len(modifiedFileLines)) + # First, go through the file and pull out the lines where there is + # now an image file marker followed by an align center directive + deleteLines = [] + for lineNumber, line in enumerate(modifiedFileLines): + m = image_marker_pattern.match(line) + if m: + print("found image marker in line %d" % lineNumber) + n = align_pattern.match(modifiedFileLines[lineNumber+1]) + if n: + print("found align center") + deleteLines.append(lineNumber) + deleteLines.append(lineNumber+1) + #When deleting, always work from the back of the list to the front + for lineNumber in reversed(deleteLines): + print(lineNumber) + del modifiedFileLines[lineNumber] + print("modifiedFileLines has %d lines after align center cleanup" % len(modifiedFileLines)) + # Now we can actually write out the new contents + try: + if not os.path.exists(modifiedFileFolder): + os.makedirs(modifiedFileFolder) + nameParts = filename.split("/") + filenamePos = len(nameParts) - 1 + modFilePath = "{0}{1}".format(modifiedFileFolder, nameParts[filenamePos]) + modRst = open(modFilePath, "w") + for rstLine in modifiedFileLines: + modRst.write(rstLine) + modRst.close() + except OSError: + print('Error: Creating directory. ' + modifiedFileFolder) + return imageCount + + +def main(): + fileCount = 0 + totalImageCount = 0 + + parser = argparse.ArgumentParser(description='replace image markup in rst files with inline mathjax markup from .txt source of images') + parser.add_argument('files', metavar='file', nargs='+', help='one or more files to scan') + parsed_args = parser.parse_args() + + # TODO: make originalRst folder and copy src/*.rst files into it + + # Because we may decide to add files to the skip list between runs, + # if we have more than one file to process, + # remove the modified file folder so we don't end up with + # zombie modifications + if len(parsed_args.files) > 1: + for outputFile in os.listdir(modifiedFileFolder): + filePath = os.path.join(modifiedFileFolder, outputFile) + try: + if os.path.isfile(filePath): + os.unlink(filePath) + except Exception as e: + print(e) + sys.exit(1) + + for filename in parsed_args.files: + doSkip = False + for skipName in skipFileList: + if filename.find(skipName) != -1: + print("skipping file: %s" % filename) + doSkip = True + runReport[filename] = ["skipped based on skipFileList"] + break + if not doSkip: + fileCount += 1 + ic = processFile(filename) + totalImageCount += ic + + print("============================================") + print("Processed %d rst files." % fileCount) + print("Found %d image lines." % totalImageCount) + + for fileKey in runReport: + print("--------------------------------------------") + print("run report for %s:" % fileKey) + print(*runReport[fileKey], sep="\n") + + print("============================================") + +if __name__ == "__main__": + main() diff --git a/doc/utils/converters/lammpsdoc/rst_anchor_check.py b/doc/utils/converters/lammpsdoc/rst_anchor_check.py new file mode 100644 index 0000000000..9c097e7d0e --- /dev/null +++ b/doc/utils/converters/lammpsdoc/rst_anchor_check.py @@ -0,0 +1,64 @@ +#! /usr/bin/env python3 +# LAMMPS Documentation Utilities +# +# Scan for duplicate anchor labels in documentation files +# +# Copyright (C) 2017 Richard Berger +# +# 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 3 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 . +import re +import sys +import argparse + +def main(): + parser = argparse.ArgumentParser(description='scan for duplicate anchor labels in documentation files') + parser.add_argument('files', metavar='file', nargs='+', help='one or more files to scan') + parsed_args = parser.parse_args() + + anchor_pattern = re.compile(r'^\.\. _(.*):$') + anchors = {} + + for filename in parsed_args.files: + #print("filename: %s" % filename) + with open(filename, 'rt') as f: + for line_number, line in enumerate(f): + m = anchor_pattern.match(line) + if m: + label = m.group(1) + #print("found label: %s" % label) + if label in anchors: + anchors[label].append((filename, line_number+1)) + else: + anchors[label] = [(filename, line_number+1)] + + print("found %d anchor labels" % len(anchors)) + + count = 0 + + for label in sorted(anchors.keys()): + if len(anchors[label]) > 1: + print(label) + count += 1 + for filename, line_number in anchors[label]: + print(" - %s:%d" % (filename, line_number)) + + + if count > 0: + print("Found %d anchor label errors." % count) + sys.exit(1) + else: + print("No anchor label errors.") + +if __name__ == "__main__": + main() diff --git a/doc/utils/converters/setup.py b/doc/utils/converters/setup.py index f4656a7f69..d85669bcc1 100644 --- a/doc/utils/converters/setup.py +++ b/doc/utils/converters/setup.py @@ -13,6 +13,6 @@ setup(name='LAMMPS Documentation Utilities', entry_points = { "console_scripts": ['txt2html = lammpsdoc.txt2html:main', 'txt2rst = lammpsdoc.txt2rst:main', - 'doc_anchor_check = lammpsdoc.doc_anchor_check:main '] + 'rst_anchor_check = lammpsdoc.rst_anchor_check:main '] }, ) From 5e6694f3bcda89237fe8cb96903abfdd81413df2 Mon Sep 17 00:00:00 2001 From: Anne Gunn Date: Fri, 21 Jun 2019 08:34:32 -0600 Subject: [PATCH 343/557] Re-enabled conversion of equations arrays. Disabled works even worse --- .../lammpsdoc/eqImg2mathjaxInline.py | 41 +++++++++++++------ 1 file changed, 29 insertions(+), 12 deletions(-) diff --git a/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py b/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py index 6db83da7fd..353eed8b6e 100644 --- a/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py +++ b/doc/utils/converters/lammpsdoc/eqImg2mathjaxInline.py @@ -21,6 +21,7 @@ import argparse import os import re +import shutil import sys @@ -37,7 +38,8 @@ imageMarker = ">>>image was here" image_marker_pattern = re.compile(r'>>>image was here') align_pattern = re.compile(r'.*:align: center') -modifiedFileFolder = "src/modifiedRst/" +modifiedRstFolder = "src/modifiedRst/" +safeRstFolder = "src/safeRst/" # Since this is a proof of concept implementation, # skip any rst files that are known to cause problems skipFileList = ["pair_tersoff_zbl.rst"] @@ -151,7 +153,13 @@ def processFile(filename): # not an equation line, so simply queue it up for output as is modifiedFileLines.append(line) if doWriteModifiedFile: - #print(*modifiedFileLines, sep="\n") + # We're going to write out a modified file, so first copy the original rst + # file into the original file folder. + nameParts = filename.split("/") + filenamePos = len(nameParts) - 1 + safeFilePath = "{0}{1}".format(safeRstFolder, nameParts[filenamePos]) + shutil.copyfile(filename, safeFilePath) + print("modifiedFileLines has %d lines before align center cleanup" % len(modifiedFileLines)) # First, go through the file and pull out the lines where there is # now an image file marker followed by an align center directive @@ -172,17 +180,13 @@ def processFile(filename): print("modifiedFileLines has %d lines after align center cleanup" % len(modifiedFileLines)) # Now we can actually write out the new contents try: - if not os.path.exists(modifiedFileFolder): - os.makedirs(modifiedFileFolder) - nameParts = filename.split("/") - filenamePos = len(nameParts) - 1 - modFilePath = "{0}{1}".format(modifiedFileFolder, nameParts[filenamePos]) + modFilePath = "{0}{1}".format(modifiedRstFolder, nameParts[filenamePos]) modRst = open(modFilePath, "w") for rstLine in modifiedFileLines: modRst.write(rstLine) modRst.close() except OSError: - print('Error: Creating directory. ' + modifiedFileFolder) + print('Error: Creating directory. ' + modifiedRstFolder) return imageCount @@ -193,16 +197,28 @@ def main(): parser = argparse.ArgumentParser(description='replace image markup in rst files with inline mathjax markup from .txt source of images') parser.add_argument('files', metavar='file', nargs='+', help='one or more files to scan') parsed_args = parser.parse_args() + print(parsed_args) - # TODO: make originalRst folder and copy src/*.rst files into it + if not os.path.exists(safeRstFolder): + os.makedirs(safeRstFolder) + if not os.path.exists(modifiedRstFolder): + os.makedirs(modifiedRstFolder) # Because we may decide to add files to the skip list between runs, # if we have more than one file to process, - # remove the modified file folder so we don't end up with + # files from both original and modified folders # zombie modifications if len(parsed_args.files) > 1: - for outputFile in os.listdir(modifiedFileFolder): - filePath = os.path.join(modifiedFileFolder, outputFile) + for outputFile in os.listdir(modifiedRstFolder): + filePath = os.path.join(modifiedRstFolder, outputFile) + try: + if os.path.isfile(filePath): + os.unlink(filePath) + except Exception as e: + print(e) + sys.exit(1) + for safeFile in os.listdir(safeRstFolder): + filePath = os.path.join(safeRstFolder, safeFile) try: if os.path.isfile(filePath): os.unlink(filePath) @@ -211,6 +227,7 @@ def main(): sys.exit(1) for filename in parsed_args.files: + print("filename: %s" % filename) doSkip = False for skipName in skipFileList: if filename.find(skipName) != -1: From c756e472aeab235f7ea7e939b45dba5abccddb73 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 5 Nov 2019 15:34:57 -0500 Subject: [PATCH 344/557] Remove Manual.txt and use variable for version --- doc/src/Manual.rst | 4 +- doc/txt/Manual.txt | 124 --------------------------------------------- 2 files changed, 2 insertions(+), 126 deletions(-) delete mode 100644 doc/txt/Manual.txt diff --git a/doc/src/Manual.rst b/doc/src/Manual.rst index c5485271e1..dd67a13427 100644 --- a/doc/src/Manual.rst +++ b/doc/src/Manual.rst @@ -1,8 +1,8 @@ LAMMPS Documentation #################### -30 Oct 2019 version -******************* +|version| version +***************** :doc:`What is a LAMMPS version? ` diff --git a/doc/txt/Manual.txt b/doc/txt/Manual.txt deleted file mode 100644 index 041a481547..0000000000 --- a/doc/txt/Manual.txt +++ /dev/null @@ -1,124 +0,0 @@ - - -LAMMPS Users Manual - - - - - - - -

    - - - -"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#comm) - -:line - -LAMMPS Documentation :c,h1 -30 Oct 2019 version :c,h2 - -"What is a LAMMPS version?"_Manual_version.html - -LAMMPS stands for Large-scale Atomic/Molecular Massively Parallel -Simulator. - -LAMMPS is a classical molecular dynamics simulation code with a focus -on materials modeling. It was designed to run efficiently on parallel -computers. It was developed originally at Sandia National -Laboratories, a US Department of Energy facility. The majority of -funding for LAMMPS has come from the US Department of Energy (DOE). -LAMMPS is an open-source code, distributed freely under the terms of -the GNU Public License (GPL). - -The "LAMMPS website"_lws has a variety of information about the code. -It includes links to an on-line version of this manual, a "mailing -list"_http://lammps.sandia.gov/mail.html where users can post -questions, and a "GitHub site"_https://github.com/lammps/lammps where -all LAMMPS development is coordinated. - -:line - -The content for this manual is part of the LAMMPS distribution. You -can build a local copy of the Manual as HTML pages or a PDF file, by -following the steps on the "Manual build"_Manual_build.html doc page. -There is also a "Developer.pdf"_Developer.pdf document which gives -a brief description of the basic code structure of LAMMPS. - -:line - -Once you are familiar with LAMMPS, you may want to bookmark "this -page"_Commands.html since it gives quick access to a doc page for -every LAMMPS command. - - - - -"Introduction"_Intro.html :olb,l -"Install LAMMPS"_Install.html :l -"Build LAMMPS"_Build.html :l -"Run LAMMPS"_Run_head.html :l -"Commands"_Commands.html :l -"Optional packages"_Packages.html :l -"Accelerate performance"_Speed.html :l -"How-to discussions"_Howto.html :l -"Example scripts"_Examples.html :l -"Auxiliary tools"_Tools.html :l -"Modify & extend LAMMPS"_Modify.html :l -"Use Python with LAMMPS"_Python_head.html :l -"Errors"_Errors.html :l -"Building the LAMMPS manual"_Manual_build.html :l -:ole - - - - From c3e52c3c8cced95f63fcf87b14c1e96aec362175 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Tue, 5 Nov 2019 15:48:00 -0500 Subject: [PATCH 345/557] Use globs for style lists --- doc/src/angles.rst | 24 +----- doc/src/bonds.rst | 19 +---- doc/src/computes.rst | 131 +---------------------------- doc/src/dihedrals.rst | 34 +------- doc/src/fixes.rst | 184 +--------------------------------------- doc/src/impropers.rst | 17 +--- doc/src/pairs.rst | 125 +-------------------------- doc/txt/angles.txt | 30 ------- doc/txt/bonds.txt | 25 ------ doc/txt/dihedrals.txt | 40 --------- doc/txt/fixes.txt | 190 ------------------------------------------ doc/txt/pairs.txt | 131 ----------------------------- 12 files changed, 14 insertions(+), 936 deletions(-) delete mode 100644 doc/txt/angles.txt delete mode 100644 doc/txt/bonds.txt delete mode 100644 doc/txt/dihedrals.txt delete mode 100644 doc/txt/fixes.txt delete mode 100644 doc/txt/pairs.txt diff --git a/doc/src/angles.rst b/doc/src/angles.rst index 84a8fad6a8..79c52a5525 100644 --- a/doc/src/angles.rst +++ b/doc/src/angles.rst @@ -4,26 +4,6 @@ Angle Styles .. toctree:: :maxdepth: 1 + :glob: - angle_charmm - angle_class2 - angle_cosine - angle_cosine_buck6d - angle_cosine_delta - angle_cosine_periodic - angle_cosine_shift - angle_cosine_shift_exp - angle_cosine_squared - angle_cross - angle_dipole - angle_fourier - angle_fourier_simple - angle_harmonic - angle_hybrid - angle_mm3 - angle_none - angle_quartic - angle_sdk - angle_table - angle_zero - + angle_* diff --git a/doc/src/bonds.rst b/doc/src/bonds.rst index 55c9702171..3019e0c177 100644 --- a/doc/src/bonds.rst +++ b/doc/src/bonds.rst @@ -4,21 +4,6 @@ Bond Styles .. toctree:: :maxdepth: 1 + :glob: - bond_class2 - bond_fene - bond_fene_expand - bond_gromos - bond_harmonic - bond_harmonic_shift - bond_harmonic_shift_cut - bond_hybrid - bond_mm3 - bond_morse - bond_none - bond_nonlinear - bond_oxdna - bond_quartic - bond_table - bond_zero - + bond_* diff --git a/doc/src/computes.rst b/doc/src/computes.rst index 1bb603f39c..1c1819a444 100644 --- a/doc/src/computes.rst +++ b/doc/src/computes.rst @@ -4,133 +4,6 @@ Computes .. toctree:: :maxdepth: 1 + :glob: - compute_ackland_atom - compute_adf - compute_angle - compute_angle_local - compute_angmom_chunk - compute_basal_atom - compute_body_local - compute_bond - compute_bond_local - compute_centro_atom - compute_chunk_atom - compute_chunk_spread_atom - compute_cluster_atom - compute_cna_atom - compute_cnp_atom - compute_com - compute_com_chunk - compute_contact_atom - compute_coord_atom - compute_damage_atom - compute_dihedral - compute_dihedral_local - compute_dilatation_atom - compute_dipole_chunk - compute_displace_atom - compute_dpd - compute_dpd_atom - compute_edpd_temp_atom - compute_entropy_atom - compute_erotate_asphere - compute_erotate_rigid - compute_erotate_sphere - compute_erotate_sphere_atom - compute_event_displace - compute_fep - compute_global_atom - compute_group_group - compute_gyration - compute_gyration_chunk - compute_gyration_shape - compute_heat_flux - compute_hexorder_atom - compute_hma - compute_improper - compute_improper_local - compute_inertia_chunk - compute_ke - compute_ke_atom - compute_ke_atom_eff - compute_ke_eff - compute_ke_rigid - compute_meso_e_atom - compute_meso_rho_atom - compute_meso_t_atom - compute_momentum - compute_msd - compute_msd_chunk - compute_msd_nongauss - compute_omega_chunk - compute_orientorder_atom - compute_pair - compute_pair_local - compute_pe - 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 - compute_smd_contact_radius - compute_smd_damage - compute_smd_hourglass_error - compute_smd_internal_energy - compute_smd_plastic_strain - compute_smd_plastic_strain_rate - compute_smd_rho - compute_smd_tlsph_defgrad - compute_smd_tlsph_dt - compute_smd_tlsph_num_neighs - compute_smd_tlsph_shape - compute_smd_tlsph_strain - compute_smd_tlsph_strain_rate - compute_smd_tlsph_stress - compute_smd_triangle_vertices - compute_smd_ulsph_num_neighs - compute_smd_ulsph_strain - compute_smd_ulsph_strain_rate - compute_smd_ulsph_stress - compute_smd_vol - compute_sna_atom - compute_spin - compute_stress_atom - compute_stress_mop - compute_tally - compute_tdpd_cc_atom - compute_temp - compute_temp_asphere - compute_temp_body - compute_temp_chunk - compute_temp_com - compute_temp_cs - compute_temp_deform - compute_temp_deform_eff - compute_temp_drude - compute_temp_eff - compute_temp_partial - compute_temp_profile - compute_temp_ramp - compute_temp_region - compute_temp_region_eff - compute_temp_rotate - compute_temp_sphere - compute_temp_uef - compute_ti - compute_torque_chunk - compute_vacf - compute_vcm_chunk - compute_voronoi_atom - compute_xrd - + compute_* diff --git a/doc/src/dihedrals.rst b/doc/src/dihedrals.rst index e14399fcb6..bab913f1c2 100644 --- a/doc/src/dihedrals.rst +++ b/doc/src/dihedrals.rst @@ -4,36 +4,6 @@ Dihedral Styles .. toctree:: :maxdepth: 1 + :glob: - dihedral_charmm - dihedral_class2 - dihedral_cosine_shift_exp - dihedral_fourier - dihedral_harmonic - dihedral_helix - dihedral_hybrid - dihedral_multi_harmonic - dihedral_nharmonic - dihedral_none - dihedral_opls - dihedral_quadratic - dihedral_spherical - dihedral_table - dihedral_table_cut - dihedral_zero - dihedral_charmm - dihedral_class2 - dihedral_cosine_shift_exp - dihedral_fourier - dihedral_harmonic - dihedral_helix - dihedral_hybrid - dihedral_multi_harmonic - dihedral_nharmonic - dihedral_none - dihedral_opls - dihedral_quadratic - dihedral_spherical - dihedral_table - dihedral_zero - + dihedral_* diff --git a/doc/src/fixes.rst b/doc/src/fixes.rst index 3678fcc853..5a85738c45 100644 --- a/doc/src/fixes.rst +++ b/doc/src/fixes.rst @@ -4,186 +4,6 @@ Fixes .. toctree:: :maxdepth: 1 + :glob: - fix_adapt - fix_adapt_fep - fix_addforce - fix_addtorque - fix_append_atoms - fix_atc - fix_atom_swap - fix_ave_atom - fix_ave_chunk - fix_ave_correlate - fix_ave_correlate_long - fix_ave_histo - fix_ave_time - fix_aveforce - fix_balance - fix_bocs - fix_bond_break - fix_bond_create - fix_bond_swap - fix_bond_react - fix_box_relax - fix_client_md - fix_cmap - fix_colvars - fix_controller - fix_deform - fix_deposit - fix_drag - fix_drude - fix_drude_transform - fix_dpd_energy - fix_dpd_source - fix_dt_reset - fix_efield - fix_ehex - fix_electron_stopping - fix_enforce2d - fix_eos_cv - fix_eos_table - fix_eos_table_rx - fix_evaporate - fix_external - fix_ffl - fix_filter_corotate - fix_flow_gauss - fix_freeze - fix_gcmc - fix_gld - fix_gle - fix_gravity - fix_grem - fix_halt - fix_heat - fix_hyper_global - fix_hyper_local - fix_imd - fix_indent - fix_ipi - fix_langevin - fix_langevin_drude - fix_langevin_eff - fix_langevin_spin - fix_latte - fix_lb_fluid - fix_lb_momentum - fix_lb_pc - fix_lb_rigid_pc_sphere - fix_lb_viscous - fix_lineforce - fix_manifoldforce - fix_meso - fix_meso_move - fix_meso_stationary - fix_momentum - fix_move - fix_mscg - fix_msst - fix_mvv_dpd - fix_neb - fix_neb_spin - fix_nh - fix_nh_eff - fix_nh_uef - fix_nph_asphere - fix_nph_body - fix_nph_sphere - fix_nphug - fix_npt_asphere - fix_npt_body - fix_npt_sphere - fix_nve - fix_nve_asphere - fix_nve_asphere_noforce - fix_nve_awpmd - fix_nve_body - fix_nve_dot - fix_nve_dotc_langevin - fix_nve_eff - fix_nve_limit - fix_nve_line - fix_nve_manifold_rattle - fix_nve_noforce - fix_nve_sphere - fix_nve_spin - fix_nve_tri - fix_nvk - fix_nvt_asphere - fix_nvt_body - fix_nvt_manifold_rattle - fix_nvt_sllod - fix_nvt_sllod_eff - fix_nvt_sphere - fix_oneway - fix_orient - fix_phonon - fix_pimd - fix_planeforce - fix_plumed - fix_poems - fix_pour - fix_precession_spin - fix_press_berendsen - fix_print - fix_property_atom - fix_python_invoke - fix_python_move - fix_qbmsst - fix_qeq - fix_qeq_comb - fix_qeq_reax - fix_qmmm - fix_qtb - fix_reaxc_bonds - fix_reaxc_species - fix_recenter - fix_restrain - fix_rhok - fix_rigid - fix_rigid_meso - fix_rx - fix_saed_vtk - fix_setforce - fix_shake - fix_shardlow - fix_smd - fix_smd_adjust_dt - fix_smd_integrate_tlsph - fix_smd_integrate_ulsph - fix_smd_move_triangulated_surface - fix_smd_setvel - fix_smd_wall_surface - fix_spring - fix_spring_chunk - fix_spring_rg - fix_spring_self - fix_srd - fix_store_force - fix_store_state - fix_temp_berendsen - fix_temp_csvr - fix_temp_rescale - fix_temp_rescale_eff - fix_tfmc - fix_thermal_conductivity - fix_ti_spring - fix_tmd - fix_ttm - fix_tune_kspace - fix_vector - fix_viscosity - fix_viscous - fix_wall - fix_wall_body_polygon - fix_wall_body_polyhedron - fix_wall_ees - fix_wall_gran - fix_wall_gran_region - fix_wall_piston - fix_wall_reflect - fix_wall_region - fix_wall_srd - + fix_* diff --git a/doc/src/impropers.rst b/doc/src/impropers.rst index c524004fc4..93b4776d2c 100644 --- a/doc/src/impropers.rst +++ b/doc/src/impropers.rst @@ -4,19 +4,6 @@ Improper Styles .. toctree:: :maxdepth: 1 + :glob: - improper_class2 - improper_cossq - improper_cvff - improper_distance - improper_distharm - improper_fourier - improper_harmonic - improper_hybrid - improper_inversion_harmonic - improper_none - improper_ring - improper_umbrella - improper_sqdistharm - improper_zero - + improper_* diff --git a/doc/src/pairs.rst b/doc/src/pairs.rst index 9124013161..4fdf2b2c69 100644 --- a/doc/src/pairs.rst +++ b/doc/src/pairs.rst @@ -4,127 +4,6 @@ Pair Styles .. toctree:: :maxdepth: 1 + :glob: - pair_adp - pair_agni - pair_airebo - pair_atm - pair_awpmd - pair_beck - pair_body_nparticle - pair_body_rounded_polygon - pair_body_rounded_polyhedron - pair_bop - pair_born - pair_brownian - pair_buck - pair_buck_long - pair_buck6d_coul_gauss - pair_charmm - pair_class2 - pair_colloid - pair_comb - pair_cosine_squared - pair_coul - pair_coul_diel - pair_coul_shield - pair_cs - pair_dipole - pair_dpd - pair_dpd_fdt - pair_drip - pair_dsmc - pair_e3b - pair_eam - pair_edip - pair_eff - pair_eim - pair_exp6_rx - pair_extep - pair_fep_soft - pair_gauss - pair_gayberne - pair_gran - pair_granular - pair_gromacs - pair_gw - pair_hbond_dreiding - pair_hybrid - pair_ilp_graphene_hbn - pair_kim - pair_kolmogorov_crespi_full - pair_kolmogorov_crespi_z - pair_lcbop - pair_lebedeva_z - pair_line_lj - pair_list - pair_lj - pair_lj96 - pair_lj_cubic - pair_lj_expand - pair_lj_long - pair_lj_smooth - pair_lj_smooth_linear - pair_lj_switch3_coulgauss - pair_local_density - pair_lubricate - pair_lubricateU - pair_mdf - pair_meamc - pair_meam_spline - pair_meam_sw_spline - pair_meso - pair_mgpt - pair_mie - pair_mm3_switch3_coulgauss - pair_momb - pair_morse - pair_multi_lucy - pair_multi_lucy_rx - pair_nb3b_harmonic - pair_nm - pair_none - pair_oxdna - pair_oxdna2 - pair_peri - pair_polymorphic - pair_python - pair_quip - pair_reaxc - pair_resquared - pair_sdk - pair_sdpd_taitwater_isothermal - pair_smd_hertz - pair_smd_tlsph - pair_smd_triangulated_surface - pair_smd_ulsph - pair_smtbq - pair_snap - pair_soft - pair_sph_heatconduction - pair_sph_idealgas - pair_sph_lj - pair_sph_rhosum - pair_sph_taitwater - pair_sph_taitwater_morris - pair_spin_dipole - pair_spin_dmi - pair_spin_exchange - pair_spin_magelec - pair_spin_neel - pair_srp - pair_sw - pair_table - pair_table_rx - pair_tersoff - pair_tersoff_mod - pair_tersoff_zbl - pair_thole - pair_tri_lj - pair_ufm - pair_vashishta - pair_yukawa - pair_yukawa_colloid - pair_zbl - pair_zero - + pair_* diff --git a/doc/txt/angles.txt b/doc/txt/angles.txt deleted file mode 100644 index 3d8a47b2eb..0000000000 --- a/doc/txt/angles.txt +++ /dev/null @@ -1,30 +0,0 @@ -Angle Styles :h1 - - diff --git a/doc/txt/bonds.txt b/doc/txt/bonds.txt deleted file mode 100644 index 48896e711c..0000000000 --- a/doc/txt/bonds.txt +++ /dev/null @@ -1,25 +0,0 @@ -Bond Styles :h1 - - diff --git a/doc/txt/dihedrals.txt b/doc/txt/dihedrals.txt deleted file mode 100644 index a862bf50a0..0000000000 --- a/doc/txt/dihedrals.txt +++ /dev/null @@ -1,40 +0,0 @@ -Dihedral Styles :h1 - - diff --git a/doc/txt/fixes.txt b/doc/txt/fixes.txt deleted file mode 100644 index d966b9a225..0000000000 --- a/doc/txt/fixes.txt +++ /dev/null @@ -1,190 +0,0 @@ -Fixes :h1 - - diff --git a/doc/txt/pairs.txt b/doc/txt/pairs.txt deleted file mode 100644 index 1f8f130e48..0000000000 --- a/doc/txt/pairs.txt +++ /dev/null @@ -1,131 +0,0 @@ -Pair Styles :h1 - - From 729eabd77146592763f3dd3ad4234cb428905c49 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 6 Nov 2019 08:32:07 -0500 Subject: [PATCH 346/557] make QUIP_LIBRARY setting consistent and backport change to .rst file only --- doc/rst/Build_extras.rst | 2 +- doc/src/Build_extras.txt | 4 ++-- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/doc/rst/Build_extras.rst b/doc/rst/Build_extras.rst index 49e3d5c801..6162940015 100644 --- a/doc/rst/Build_extras.rst +++ b/doc/rst/Build_extras.rst @@ -1258,7 +1258,7 @@ lib/quip/README file for details on how to do this. CMake will not download and build the QUIP library. But once you have done that, a CMake build of LAMMPS with "-D PKG\_USER-QUIP=yes" should -work. Set QUIP\_LIBRARIES if CMake cannot find the QUIP library. +work. Set QUIP\_LIBRARY if CMake cannot find the QUIP library. **Traditional make**\ : diff --git a/doc/src/Build_extras.txt b/doc/src/Build_extras.txt index b315e244c5..114aeda7af 100644 --- a/doc/src/Build_extras.txt +++ b/doc/src/Build_extras.txt @@ -1034,11 +1034,11 @@ lib/quip/README file for details on how to do this. [CMake build]: --D QUIP_LIBRARIES=path # path to libquip.a (only needed if a custom location) :pre +-D QUIP_LIBRARY=path # path to libquip.a (only needed if a custom location) :pre CMake will not download and build the QUIP library. But once you have done that, a CMake build of LAMMPS with "-D PKG_USER-QUIP=yes" should -work. Set QUIP_LIBRARIES if CMake cannot find the QUIP library. +work. Set QUIP_LIBRARY if CMake cannot find the QUIP library. [Traditional make]: From 2fd9a2790263c5641540efd8b0e6d47f1dc9abdd Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 6 Nov 2019 08:33:05 -0500 Subject: [PATCH 347/557] update kim_commands.rst from .txt file --- doc/rst/kim_commands.rst | 352 ++++++++++++++++++++++++++++++++++++--- 1 file changed, 326 insertions(+), 26 deletions(-) diff --git a/doc/rst/kim_commands.rst b/doc/rst/kim_commands.rst index e9393200d7..9f0b5a6775 100644 --- a/doc/rst/kim_commands.rst +++ b/doc/rst/kim_commands.rst @@ -9,6 +9,9 @@ kim\_interactions command kim\_query command ================== +kim\_param command +================== + Syntax """""" @@ -18,15 +21,36 @@ Syntax kim_init model user_units unitarg kim_interactions typeargs kim_query variable formatarg query_function queryargs + kim_param get param_name index_range variables formatarg + kim_param set param_name index_range values + +.. _formatarg\_options: + + * model = name of the KIM interatomic model (the KIM ID for models archived in OpenKIM) * user\_units = the LAMMPS :doc:`units ` style assumed in the LAMMPS input script * unitarg = *unit\_conversion\_mode* (optional) * 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) +* variable(s) = single name or list of names of (string style) LAMMPS variable(s) where a query result or parameter get result is stored. Variables that do not exist will be created by the command. +* formatarg = *list, split, or explicit* (optional): + + .. parsed-literal:: + + *list* = returns a single string with a list of space separated values + (e.g. "1.0 2.0 3.0"), which is placed in a LAMMPS variable as + defined by the *variable* argument. [default for *kim_query*] + *split* = returns the values separately in new variables with names based + on the prefix specified in *variable* and a number appended to + indicate which element in the list of values is in the variable. + *explicit* = returns the values separately in one more more variable names + provided as arguments that preceed *formatarg*\ . [default for *kim_param*] + * 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 +* param\_name = name of a KIM portable model parameter +* index\_range = KIM portable model parameter index range (an integer for a single element, or pair of integers separated by a colon for a range of elements) +* values = new value(s) to replace the current value(s) of a KIM portable model parameter Examples """""""" @@ -39,9 +63,11 @@ Examples 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_039297821658_000 real + kim_init Sim_LAMMPS_IFF_PCFF_HeinzMishraLinEmami_2015Ver1v5_FccmetalsMineralsSolventsPolymers__SM_039297821658_000 real kim_interactions fixed_types kim_query a0 get_lattice_constant_cubic crystal=["fcc"] species=["Al"] units=["angstrom"] + kim_param get gamma 1 varGamma + kim_param set gamma 1 3.0 Description """"""""""" @@ -90,6 +116,10 @@ Types of IMs in OpenKIM There are two types of IMs archived in OpenKIM: +.. _PM\_type: + + + 1. 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 `_) 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 `_). 2. 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. @@ -126,7 +156,7 @@ The URL for the Model Page is constructed from the https://openkim.org/id/extended_KIM_ID -For example for the Stillinger-Weber potential +For example, for the Stillinger--Weber potential listed above the Model Page is located at: @@ -224,7 +254,8 @@ potential for Al: 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*. +units. To address this *kim\_init* offers the *unit\_conversion\_mode* +as shown below. If unit conversion mode *is* active, then *kim\_init* calls the LAMMPS :doc:`units ` command to set the units to the IM's required or preferred units. Conversion factors between the IM's units and the *user\_units* @@ -284,7 +315,7 @@ 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 -from a file. For example if a configuration of atoms is read in from a +from a file. For example, if a configuration of atoms is read in from a dump file using the :doc:`read\_dump ` command, the following can be done to convert the box and all atomic positions to the correct units: @@ -408,14 +439,40 @@ Using OpenKIM Web Queries in LAMMPS (*kim\_query*) ^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ 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 `_. The *kim\_query* command must be preceded -by a *kim\_init* command. The result of the query is stored in a -:doc:`string style variable `, the name of which is given as the first -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 :ref:`example ` below.) +of an IM set by *kim\_init* for material properties archived in +`OpenKIM `_. + +.. note:: + + The *kim\_query* command must be preceded by a *kim\_init* command. + +The syntax for the *kim\_query* command is as follows: + + +.. parsed-literal:: + + kim_query variable formatarg query_function queryargs + +The result of the query is stored in one or more +:doc:`string style variables ` as determined by the +optional *formatarg* argument :ref:`documented above `. +For the "list" setting of *formatarg* (or if *formatarg* is not +specified), the result is returned as a space-separated list of +values in *variable*\ . +The *formatarg* keyword "split" separates the result values into +individual variables of the form *prefix\_I*, where *prefix* is set to 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. (Note that the "explicit" setting of +*formatarg* is not supported by *kim\_query*.) + +.. note:: + + *kim\_query* only supports queries that return a single result or + an array of values. More complex queries that return a JSON structure + are not currently supported. An attempt to use *kim\_query* in such + cases will generate an error. + The second required argument *query\_function* is the name of the query function to be called (e.g. *get\_lattice\_constant\_cubic*). All following :doc:`arguments ` are parameters handed over to @@ -443,8 +500,8 @@ is available on the OpenKIM webpage at `query documentation `_ to see which methods are available for a given *query function*\ . -*kim\_query* Usage Examples and Further Clarifications: -""""""""""""""""""""""""""""""""""""""""""""""""""""""" +*kim\_query* Usage Examples and Further Clarifications +^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ 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. @@ -473,10 +530,6 @@ 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}". -.. _split\_example: - - - **Define an equilibrium hcp crystal** @@ -494,12 +547,11 @@ changed to: "lattice fcc ${a0}\*${\_u_distance}". 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. +The *formatarg* keyword "split" places the two values into +the variables *latconst\_1* and *latconst\_2*. (These variables are +created if they do not already exist.) For convenience the variables +*a0* and *c0* are created in order to make the remainder of the +input script more readable. **Define a crystal at finite temperature accounting for thermal expansion** @@ -560,6 +612,254 @@ ideal fcc cohesive energy of the atoms in the system obtained from from these programs are queried is tracked. No other information about the nature of the query or its source is recorded. +Accessing KIM Model Parameters from LAMMPS (*kim\_param*) +^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ + +All IMs are functional forms containing a set of +parameters. The values of these parameters are typically +selected to best reproduce a training set of quantum mechanical +calculations or available experimental data. For example, a +Lennard-Jones potential intended to model argon might have the values of +its two parameters, epsilon and sigma, fit to the +dimer dissociation energy or thermodynamic properties at a critical point +of the phase diagram. + +Normally a user employing an IM should not modify its parameters since, +as noted above, these are selected to reproduce material properties. +However, there are cases where accessing and modifying IM parameters +is desired, such as for assessing uncertainty, fitting an IM, +or working with an ensemble of IMs. As explained :ref:`above `, +IMs archived in OpenKIM are either Portable Models (PMs) or +Simulator Models (SMs). KIM PMs are complete independent implementations +of an IM, whereas KIM SMs are wrappers to an IM implemented within LAMMPS. +Two different mechanisms are provided for accessing IM parameters in these +two cases: + +* For a KIM PM, the *kim\_param* command can be used to *get* and *set* the values of the PM's parameters as explained below. +* For a KIM SM, the user should consult the documentation page for the specific IM and follow instructions there for how to modify its parameters (if possible). + +The *kim\_param get* and *kim\_param set* commands provide an interface +to access and change the parameters of a KIM PM that "publishes" its +parameters and makes them publicly available (see the +`KIM API documentation `_ +for details). + +.. note:: + + The *kim\_param get/set* commands must be preceded by *kim\_init*. + The *kim\_param set* command must additionally be preceded by a + *kim\_interactions* command (or alternatively by a *pair\_style kim* + and *pair\_coeff* commands). The *kim\_param set* command may be used wherever a *pair\_coeff* command may occur. + +The syntax for the *kim\_param* command is as follows: + + +.. parsed-literal:: + + kim_param get param_name index_range variable formatarg + kim_param set param_name index_range values + +Here, *param\_name* is the name of a KIM PM parameter (which is published +by the PM and available for access). The specific string used to identify +a parameter is defined by the PM. For example, for the +`Stillinger--Weber (SW) potential in OpenKIM `_, +the parameter names are *A, B, p, q, sigma, gamma, cutoff, lambda, costheta0*\ . + +.. note:: + + The list of all the parameters that a PM exposes for access/mutation are + automatically written to the lammps log file when *kim\_init* is called. + +Each published parameter of a KIM PM takes the form of an array of +numerical values. The array can contain one element for a single-valued +parameter, or a set of values. For example, the +`multispecies SW potential for the Zn-Cd-Hg-S-Se-Te system `_ +has the same parameter names as the +`single-species SW potential `_, +but each parameter array contains 21 entries that correspond to the parameter +values used for each pairwise combination of the model's six supported species +(this model does not have parameters specific to individual ternary +combinations of its supported species). + +The *index\_range* argument may either be an integer referring to +a specific element within the array associated with the parameter +specified by *param\_name*, or a pair of integers separated by a colon +that refer to a slice of this array. In both cases, one-based indexing is +used to refer to the entries of the array. + +The result of a *get* operation for a specific *index\_range* is stored in +one or more :doc:`LAMMPS string style variables ` as determined +by the optional *formatarg* argument :ref:`documented above. ` +If not specified, the default for *formatarg* is "explicit" for the +*kim\_param* command. + +For the case where the result is an array with multiple values +(i.e. *index\_range* contains a range), the optional "split" or "explicit" +*formatarg* keywords can be used to separate the results into multiple +variables; see the examples below. +Multiple parameters can be retrieved with a single call to *kim\_param get* +by repeating the argument list following *get*\ . + +For a *set* operation, the *values* argument contains the new value(s) +for the element(s) of the parameter specified by *index\_range*. For the case +where multiple values are being set, *values* contains a set of values +separated by spaces. Multiple parameters can be set with a single call to +*kim\_param set* by repeating the argument list following *set*\ . + +*kim\_param* Usage Examples and Further Clarifications +^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^^ + +Examples of getting and setting KIM PM parameters with further +clarifications are provided below. + +**Getting a scalar parameter** + + +.. parsed-literal:: + + kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 metal + ... + kim_param get A 1 VARA + +In this case, the value of the SW *A* parameter is retrieved and placed +in the LAMMPS variable *VARA*\ . The variable *VARA* can be used +in the remainder of the input script in the same manner as any other +LAMMPS variable. + +**Getting multiple scalar parameters with a single call** + + +.. parsed-literal:: + + kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 metal + ... + kim_param get A 1 VARA B 1 VARB + +This retrieves the *A* and *B* parameters of the SW potential and stores +them in the LAMMPS variables *VARA* and *VARB*\ . + +**Getting a range of values from a parameter** + +There are several options when getting a range of values from a parameter +determined by the *formatarg* argument. + + +.. parsed-literal:: + + kim_init SW_ZhouWardMartin_2013_CdTeZnSeHgS__MO_503261197030_002 metal + ... + kim_param get lambda 7:9 LAM_TeTe LAM_TeZn LAM_TeSe + +In this case, *formatarg* is not specified and therefore the default +"explicit" mode is used. (The behavior would be the same if the word +*explicit* were added after *LAM\_TeSe*.) Elements 7, 8 and 9 of parameter +lambda retrieved by the *get* operation are placed in the LAMMPS variables +*LAM\_TeTe*, *LAM\_TeZn* and *LAM\_TeSe*, respectively. + +.. note:: + + In the above example, elements 7--9 of the lambda parameter correspond + to Te-Te, Te-Zm and Te-Se interactions. This can be determined by visiting + the `model page for the specified potential `_ + and looking at its parameter file linked to at the bottom of the page + (file with .param ending) and consulting the README documentation + provided with the driver for the PM being used. A link to the driver + is provided at the top of the model page. + + +.. parsed-literal:: + + kim_init SW_ZhouWardMartin_2013_CdTeZnSeHgS__MO_503261197030_002 metal + ... + kim_param get lambda 15:17 LAMS list + variable LAM_VALUE index ${LAMS} + label loop_on_lambda + ... + ... do something with current value of lambda + ... + next LAM_VALUE + jump SELF loop_on_lambda + +In this case, the "list" mode of *formatarg* is used. +The result of the *get* operation is stored in the LAMMPS variable +*LAMS* as a string containing the three retrieved values separated +by spaces, e.g "1.0 2.0 3.0". This can be used in LAMMPS with an +*index* variable to access the values one at a time within a loop +as shown in the example. At each iteration of the loop *LAM\_VALUE* +contains the current value of lambda. + + +.. parsed-literal:: + + kim_init SW_ZhouWardMartin_2013_CdTeZnSeHgS__MO_503261197030_002 metal + ... + kim_param get lambda 15:17 LAM split + +In this case, the "split" mode of *formatarg* is used. +The three values retrieved by the *get* operation are stored in +the three LAMMPS variables *LAM\_15*, *LAM\_16* and *LAM\_17*. +The provided name "LAM" is used as prefix and the location in +the lambda array is appended to create the variable names. + +**Setting a scalar parameter** + + +.. parsed-literal:: + + kim_init SW_StillingerWeber_1985_Si__MO_405512056662_005 metal + ... + kim_interactions Si + kim_param set gamma 1 2.6 + +Here, the SW potential's gamma parameter is set to 2.6. Note that the *get* +and *set* commands work together, so that a *get* following a *set* +operation will return the new value that was set. For example: + + +.. parsed-literal:: + + ... + kim_interactions Si + kim_param get gamma 1 ORIG_GAMMA + kim_param set gamma 1 2.6 + kim_param get gamma 1 NEW_GAMMA + ... + print "original gamma = ${ORIG_GAMMA}, new gamma = ${NEW_GAMMA}" + +Here, *ORIG\_GAMMA* will contain the original gamma value for the SW +potential, while *NEW\_GAMMA* will contain the value 2.6. + +**Setting multiple scalar parameters with a single call** + + +.. parsed-literal:: + + kim_init SW_ZhouWardMartin_2013_CdTeZnSeHgS__MO_503261197030_002 metal + ... + kim_interactions Cd Te + variable VARG equal 2.6 + variable VARS equal 2.0951 + kim_param set gamma 1 ${VARG} sigma 3 ${VARS} + +In this case, the first element of the *gamma* parameter and +third element of the *sigma* parameter are set to 2.6 and 2.0951, +respectively. This example also shows how LAMMPS variables can +be used when setting parameters. + +**Setting a range of values of a parameter** + + +.. parsed-literal:: + + kim_init SW_ZhouWardMartin_2013_CdTeZnSeHgS__MO_503261197030_002 metal + ... + kim_interactions Cd Te Zn Se Hg S + kim_param set sigma 2:6 2.35214 2.23869 2.04516 2.43269 1.80415 + +In this case, elements 2 through 6 of the parameter *sigma* +are set to the values 2.35214, 2.23869, 2.04516, 2.43269 and 1.80415 in +order. + Citation of OpenKIM IMs ----------------------- From f80c527b1791cb163eba508a3a22db26dadd365e Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 6 Nov 2019 14:15:25 -0700 Subject: [PATCH 348/557] Commit JT 100619 - modified precession and Langevin/spin --- src/SPIN/compute_spin.cpp | 3 ++- src/SPIN/fix_langevin_spin.cpp | 26 ++++++++++++++------------ src/SPIN/fix_langevin_spin.h | 10 +++++----- src/SPIN/fix_precession_spin.cpp | 12 ++++++++---- 4 files changed, 29 insertions(+), 22 deletions(-) diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 9cd7f5473e..6f1e72ef7e 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -104,7 +104,8 @@ void ComputeSpin::compute_vector() mag[0] += sp[i][0]; mag[1] += sp[i][1]; mag[2] += sp[i][2]; - magenergy -= 2.0*(sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); + // magenergy -= 2.0*(sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); + magenergy -= (sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); tx = sp[i][1]*fm[i][2]-sp[i][2]*fm[i][1]; ty = sp[i][2]*fm[i][0]-sp[i][0]*fm[i][2]; tz = sp[i][0]*fm[i][1]-sp[i][1]*fm[i][0]; diff --git a/src/SPIN/fix_langevin_spin.cpp b/src/SPIN/fix_langevin_spin.cpp index ec9c98c4f8..e7bbacca6b 100644 --- a/src/SPIN/fix_langevin_spin.cpp +++ b/src/SPIN/fix_langevin_spin.cpp @@ -30,7 +30,8 @@ #include "math_const.h" #include "memory.h" #include "modify.h" -#include "random_park.h" +// #include "random_park.h" +#include "random_mars.h" #include "respa.h" #include "update.h" #include "utils.h" @@ -74,7 +75,8 @@ FixLangevinSpin::FixLangevinSpin(LAMMPS *lmp, int narg, char **arg) : // initialize Marsaglia RNG with processor-unique seed - random = new RanPark(lmp,seed + comm->me); + // random = new RanPark(lmp,seed + comm->me); + random = new RanMars(lmp,seed + comm->me); } @@ -82,8 +84,6 @@ FixLangevinSpin::FixLangevinSpin(LAMMPS *lmp, int narg, char **arg) : FixLangevinSpin::~FixLangevinSpin() { - memory->destroy(spi); - memory->destroy(fmi); delete random; } @@ -113,15 +113,14 @@ void FixLangevinSpin::init() } if (flag_force >= flag_lang) error->all(FLERR,"Fix langevin/spin has to come after all other spin fixes"); - memory->create(spi,3,"langevin:spi"); - memory->create(fmi,3,"langevin:fmi"); - gil_factor = 1.0/(1.0+(alpha_t)*(alpha_t)); - dts = update->dt; + dts = 0.25 * update->dt; double hbar = force->hplanck/MY_2PI; // eV/(rad.THz) double kb = force->boltz; // eV/K - D = (MY_2PI*alpha_t*gil_factor*kb*temp); + // D = (MY_2PI*alpha_t*gil_factor*kb*temp); + D = (1.0/MY_2PI)*(MY_2PI*alpha_t*gil_factor*kb*temp); + // D = (12.0/MY_2PI)*(MY_2PI*alpha_t*gil_factor*kb*temp); D /= (hbar*dts); sigma = sqrt(2.0*D); } @@ -157,9 +156,12 @@ void FixLangevinSpin::add_tdamping(double spi[3], double fmi[3]) void FixLangevinSpin::add_temperature(double fmi[3]) { - double rx = sigma*(2.0*random->uniform() - 1.0); - double ry = sigma*(2.0*random->uniform() - 1.0); - double rz = sigma*(2.0*random->uniform() - 1.0); + // double rx = sigma*(2.0*random->uniform() - 1.0); + // double ry = sigma*(2.0*random->uniform() - 1.0); + // double rz = sigma*(2.0*random->uniform() - 1.0); + double rx = sigma*random->gaussian(); + double ry = sigma*random->gaussian(); + double rz = sigma*random->gaussian(); // adding the random field diff --git a/src/SPIN/fix_langevin_spin.h b/src/SPIN/fix_langevin_spin.h index b581b70d34..aabee7b37b 100644 --- a/src/SPIN/fix_langevin_spin.h +++ b/src/SPIN/fix_langevin_spin.h @@ -32,12 +32,11 @@ class FixLangevinSpin : public Fix { void init(); void setup(int); void post_force_respa(int, int, int); - void add_tdamping(double spi[3], double fmi[3]); // add transverse damping - void add_temperature(double fmi[3]); // add temperature - int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags + void add_tdamping(double *, double *); // add transverse damping + void add_temperature(double *); // add temperature + int tdamp_flag, ldamp_flag, temp_flag; // damping and temperature flags protected: - double *spi, *fmi; double alpha_t; // transverse mag. damping double dts; // magnetic timestep double temp; // spin bath temperature @@ -48,7 +47,8 @@ class FixLangevinSpin : public Fix { class Compute *temperature; int nlevels_respa; - class RanPark *random; + // class RanPark *random; + class RanMars *random; int seed; }; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 3749b68d28..263118f5fb 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -257,7 +257,8 @@ void FixPrecessionSpin::post_force(int /* vflag */) if (zeeman_flag) { // compute Zeeman interaction compute_zeeman(i,fmi); - epreci -= 2.0*hbar*(spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); + // epreci -= 2.0*hbar*(spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); + epreci -= hbar*(spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); } if (aniso_flag) { // compute magnetic anisotropy @@ -295,9 +296,12 @@ void FixPrecessionSpin::compute_single_precession(int i, double spi[3], double f void FixPrecessionSpin::compute_zeeman(int i, double fmi[3]) { double **sp = atom->sp; - fmi[0] += 0.5*sp[i][3]*hx; - fmi[1] += 0.5*sp[i][3]*hy; - fmi[2] += 0.5*sp[i][3]*hz; + // fmi[0] += 0.5*sp[i][3]*hx; + // fmi[1] += 0.5*sp[i][3]*hy; + // fmi[2] += 0.5*sp[i][3]*hz; + fmi[0] += sp[i][3]*hx; + fmi[1] += sp[i][3]*hy; + fmi[2] += sp[i][3]*hz; } /* ---------------------------------------------------------------------- */ From eaef8089a1f3b714dca4d46513446f5ac9af2079 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 6 Nov 2019 16:53:43 -0500 Subject: [PATCH 349/557] Add LAMMPSLexer for LAMMPS code-blocks in docs --- doc/src/Commands_input.rst | 4 +- doc/src/Commands_parse.rst | 14 ++- doc/txt/Commands_input.txt | 60 ----------- doc/txt/Commands_parse.txt | 136 ------------------------- doc/utils/sphinx-config/LAMMPSLexer.py | 57 +++++++++++ doc/utils/sphinx-config/conf.py | 6 ++ 6 files changed, 74 insertions(+), 203 deletions(-) delete mode 100644 doc/txt/Commands_input.txt delete mode 100644 doc/txt/Commands_parse.txt create mode 100644 doc/utils/sphinx-config/LAMMPSLexer.py diff --git a/doc/src/Commands_input.rst b/doc/src/Commands_input.rst index 39b11d2639..ce93f65d81 100644 --- a/doc/src/Commands_input.rst +++ b/doc/src/Commands_input.rst @@ -17,7 +17,7 @@ one line at a time and each command takes effect when it is read. Thus this sequence of commands: -.. parsed-literal:: +.. code-block:: LAMMPS timestep 0.5 run 100 @@ -26,7 +26,7 @@ Thus this sequence of commands: does something different than this sequence: -.. parsed-literal:: +.. code-block:: LAMMPS run 100 timestep 0.5 diff --git a/doc/src/Commands_parse.rst b/doc/src/Commands_parse.rst index c79dcab4e1..91a11089a8 100644 --- a/doc/src/Commands_parse.rst +++ b/doc/src/Commands_parse.rst @@ -22,6 +22,10 @@ comment after a trailing "&" character will prevent the command from continuing on the next line. Also note that for multi-line commands a single leading "#" will comment out the entire command. +.. code-block:: LAMMPS + + # this is a comment + (3) The line is searched repeatedly for $ characters, which indicate variables that are replaced with a text string. See an exception in (6). @@ -47,7 +51,7 @@ to use numeric formulas in an input script without having to assign them to variable names. For example, these 3 input script lines: -.. parsed-literal:: +.. code-block:: LAMMPS variable X equal (xlo+xhi)/2+sqrt(v_area) region 1 block $X 2 INF INF EDGE EDGE @@ -56,7 +60,7 @@ them to variable names. For example, these 3 input script lines: can be replaced by -.. parsed-literal:: +.. code-block:: LAMMPS region 1 block $((xlo+xhi)/2+sqrt(v_area)) 2 INF INF EDGE EDGE @@ -72,7 +76,7 @@ specified a high-precision "%.20g" is used as the default. This can be useful for formatting print output to a desired precision: -.. parsed-literal:: +.. code-block:: LAMMPS print "Final energy per atom: $(pe/atoms:%10.3f) eV/atom" @@ -81,7 +85,7 @@ contain nested $ characters for other variables to substitute for. Thus you cannot do this: -.. parsed-literal:: +.. code-block:: LAMMPS variable a equal 2 variable b2 equal 4 @@ -113,7 +117,7 @@ can be enclosed in triple quotes, in which case "&" characters are not needed. For example: -.. parsed-literal:: +.. code-block:: LAMMPS print "Volume = $v" print 'Volume = $v' diff --git a/doc/txt/Commands_input.txt b/doc/txt/Commands_input.txt deleted file mode 100644 index 8b3dda741b..0000000000 --- a/doc/txt/Commands_input.txt +++ /dev/null @@ -1,60 +0,0 @@ -"Higher level section"_Commands.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 - -LAMMPS input scripts :h3 - -LAMMPS executes by reading commands from a input script (text file), -one line at a time. When the input script ends, LAMMPS exits. Each -command causes LAMMPS to take some action. It may set an internal -variable, read in a file, or run a simulation. Most commands have -default settings, which means you only need to use the command if you -wish to change the default. - -In many cases, the ordering of commands in an input script is not -important. However the following rules apply: - -(1) LAMMPS does not read your entire input script and then perform a -simulation with all the settings. Rather, the input script is read -one line at a time and each command takes effect when it is read. -Thus this sequence of commands: - -timestep 0.5 -run 100 -run 100 :pre - -does something different than this sequence: - -run 100 -timestep 0.5 -run 100 :pre - -In the first case, the specified timestep (0.5 fs) is used for two -simulations of 100 timesteps each. In the 2nd case, the default -timestep (1.0 fs) is used for the 1st 100 step simulation and a 0.5 fs -timestep is used for the 2nd one. - -(2) Some commands are only valid when they follow other commands. For -example you cannot set the temperature of a group of atoms until atoms -have been defined and a group command is used to define which atoms -belong to the group. - -(3) Sometimes command B will use values that can be set by command A. -This means command A must precede command B in the input script if it -is to have the desired effect. For example, the -"read_data"_read_data.html command initializes the system by setting -up the simulation box and assigning atoms to processors. If default -values are not desired, the "processors"_processors.html and -"boundary"_boundary.html commands need to be used before read_data to -tell LAMMPS how to map processors to the simulation box. - -Many input script errors are detected by LAMMPS and an ERROR or -WARNING message is printed. The "Errors"_Errors.html doc page gives -more information on what errors mean. The documentation for each -command lists restrictions on how the command can be used. - diff --git a/doc/txt/Commands_parse.txt b/doc/txt/Commands_parse.txt deleted file mode 100644 index 13a4c2699d..0000000000 --- a/doc/txt/Commands_parse.txt +++ /dev/null @@ -1,136 +0,0 @@ -"Higher level section"_Commands.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 - -Parsing rules for input scripts :h3 - -Each non-blank line in the input script is treated as a command. -LAMMPS commands are case sensitive. Command names are lower-case, as -are specified command arguments. Upper case letters may be used in -file names or user-chosen ID strings. - -Here are 6 rules for how each line in the input script is parsed by -LAMMPS: - -(1) If the last printable character on the line is a "&" character, -the command is assumed to continue on the next line. The next line is -concatenated to the previous line by removing the "&" character and -line break. This allows long commands to be continued across two or -more lines. See the discussion of triple quotes in (6) for how to -continue a command across multiple line without using "&" characters. - -(2) All characters from the first "#" character onward are treated as -comment and discarded. See an exception in (6). Note that a -comment after a trailing "&" character will prevent the command from -continuing on the next line. Also note that for multi-line commands a -single leading "#" will comment out the entire command. - -(3) The line is searched repeatedly for $ characters, which indicate -variables that are replaced with a text string. See an exception in -(6). - -If the $ is followed by curly brackets, then the variable name is the -text inside the curly brackets. If no curly brackets follow the $, -then the variable name is the single character immediately following -the $. Thus $\{myTemp\} and $x refer to variable names "myTemp" and -"x". - -How the variable is converted to a text string depends on what style -of variable it is; see the "variable"_variable.html doc page for details. -It can be a variable that stores multiple text strings, and return one -of them. The returned text string can be multiple "words" (space -separated) which will then be interpreted as multiple arguments in the -input command. The variable can also store a numeric formula which -will be evaluated and its numeric result returned as a string. - -As a special case, if the $ is followed by parenthesis, then the text -inside the parenthesis is treated as an "immediate" variable and -evaluated as an "equal-style variable"_variable.html. This is a way -to use numeric formulas in an input script without having to assign -them to variable names. For example, these 3 input script lines: - -variable X equal (xlo+xhi)/2+sqrt(v_area) -region 1 block $X 2 INF INF EDGE EDGE -variable X delete :pre - -can be replaced by - -region 1 block $((xlo+xhi)/2+sqrt(v_area)) 2 INF INF EDGE EDGE :pre - -so that you do not have to define (or discard) a temporary variable X. - -Additionally, the "immediate" variable expression may be followed by a -colon, followed by a C-style format string, e.g. ":%f" or ":%.10g". -The format string must be appropriate for a double-precision -floating-point value. The format string is used to output the result -of the variable expression evaluation. If a format string is not -specified a high-precision "%.20g" is used as the default. - -This can be useful for formatting print output to a desired precision: - -print "Final energy per atom: $(pe/atoms:%10.3f) eV/atom" :pre - -Note that neither the curly-bracket or immediate form of variables can -contain nested $ characters for other variables to substitute for. -Thus you cannot do this: - -variable a equal 2 -variable b2 equal 4 -print "B2 = $\{b$a\}" :pre - -Nor can you specify this $($x-1.0) for an immediate variable, but -you could use $(v_x-1.0), since the latter is valid syntax for an -"equal-style variable"_variable.html. - -See the "variable"_variable.html command for more details of how -strings are assigned to variables and evaluated, and how they can be -used in input script commands. - -(4) The line is broken into "words" separated by white-space (tabs, -spaces). Note that words can thus contain letters, digits, -underscores, or punctuation characters. - -(5) The first word is the command name. All successive words in the -line are arguments. - -(6) If you want text with spaces to be treated as a single argument, -it can be enclosed in either single or double or triple quotes. A -long single argument enclosed in single or double quotes can span -multiple lines if the "&" character is used, as described above. When -the lines are concatenated together (and the "&" characters and line -breaks removed), the text will become a single line. If you want -multiple lines of an argument to retain their line breaks, the text -can be enclosed in triple quotes, in which case "&" characters are not -needed. For example: - -print "Volume = $v" -print 'Volume = $v' -if "$\{steps\} > 1000" then quit -variable a string "red green blue & - purple orange cyan" -print """ -System volume = $v -System temperature = $t -""" :pre - -In each case, the single, double, or triple quotes are removed when -the single argument they enclose is stored internally. - -See the "dump modify format"_dump_modify.html, "print"_print.html, -"if"_if.html, and "python"_python.html commands for examples. - -A "#" or "$" character that is between quotes will not be treated as a -comment indicator in (2) or substituted for as a variable in (3). - -NOTE: If the argument is itself a command that requires a quoted -argument (e.g. using a "print"_print.html command as part of an -"if"_if.html or "run every"_run.html command), then single, double, or -triple quotes can be nested in the usual manner. See the doc pages -for those commands for examples. Only one of level of nesting is -allowed, but that should be sufficient for most use cases. - diff --git a/doc/utils/sphinx-config/LAMMPSLexer.py b/doc/utils/sphinx-config/LAMMPSLexer.py new file mode 100644 index 0000000000..6436be410d --- /dev/null +++ b/doc/utils/sphinx-config/LAMMPSLexer.py @@ -0,0 +1,57 @@ +from pygments.lexer import RegexLexer, words +from pygments.token import * + +LAMMPS_COMMANDS = ("angle_coeff", "angle_style", "atom_modify", "atom_style", +"balance", "bond_coeff", "bond_style", "bond_write", "boundary", "box", +"change_box", "clear", "comm_modify", "comm_style", "compute", +"compute_modify", "create_atoms", "create_bonds", "create_box", "delete_atoms", +"delete_bonds", "dielectric", "dihedral_coeff", "dihedral_style", "dimension", +"displace_atoms", "dump", "dump_modify", "dynamical_matrix", "echo", "fix", +"fix_modify", "group", "group2ndx", "hyper", "if", "improper_coeff", +"improper_style", "include", "info", "jump", "kim_init", "kim_interactions", +"kim_param", "kim_query", "kspace_modify", "kspace_style", "label", "lattice", +"log", "mass", "message", "minimize", "min_modify", "min_style", "molecule", +"ndx2group", "neb", "neb/spin", "neighbor", "neigh_modify", "newton", "next", +"package", "pair_coeff", "pair_modify", "pair_style", "pair_write", +"partition", "prd", "print", "processors", "python", "quit", "read_data", +"read_dump", "read_restart", "region", "replicate", "rerun", "reset_ids", +"reset_timestep", "restart", "run", "run_style", "server", "set", "shell", +"special_bonds", "suffix", "tad", "temper", "temper/grem", "temper/npt", +"thermo", "thermo_modify", "thermo_style", "then", "third_order", "timer", "timestep", +"uncompute", "undump", "unfix", "units", "variable", "velocity", "write_coeff", +"write_data", "write_dump", "write_restart") + +class LAMMPSLexer(RegexLexer): + name = 'LAMMPS' + tokens = { + 'root': [ + (words(LAMMPS_COMMANDS, suffix=r'\b', prefix=r'^'), Keyword), + (r'#.*?\n', Comment), + ('"', String, 'string'), + ('\'', String, 'single_quote_string'), + (r'[0-9]+(\.[0-9]+)?([eE]\-?[0-9]+)?', Number), + ('\$?\(', Name.Variable, 'expression'), + ('\$\{', Name.Variable, 'variable'), + (r'[\w_\.\[\]]+', Name), + (r'\$[\w_]+', Name.Variable), + (r'\s+', Whitespace), + (r'[\+\-\*\/&=<>]', Operator), + ], + 'variable' : [ + ('[^\}]+', Name.Variable), + ('\}', Name.Variable, '#pop'), + ], + 'string' : [ + ('[^"]+', String), + ('"', String, '#pop'), + ], + 'single_quote_string' : [ + ('[^\']+', String), + ('\'', String, '#pop'), + ], + 'expression' : [ + ('[^\(\)]+', Name.Variable), + ('\(', Name.Variable, 'expression'), + ('\)', Name.Variable, '#pop'), + ] + } diff --git a/doc/utils/sphinx-config/conf.py b/doc/utils/sphinx-config/conf.py index 727a5f7612..70a96e1614 100644 --- a/doc/utils/sphinx-config/conf.py +++ b/doc/utils/sphinx-config/conf.py @@ -317,3 +317,9 @@ if spelling_spec: spelling_lang='en_US' spelling_word_list_filename='false_positives.txt' + +sys.path.append(os.path.join(os.path.dirname(__file__), '.')) +import LAMMPSLexer +from sphinx.highlighting import lexers + +lexers['LAMMPS'] = LAMMPSLexer.LAMMPSLexer(startinline=True) From 3f10c4fcdc378c07349529fde661467694e4d84b Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 6 Nov 2019 23:33:14 -0500 Subject: [PATCH 350/557] Update Manual_build.rst and remove Manual_build.txt --- doc/src/Manual_build.rst | 58 +++++------------ doc/txt/Manual_build.txt | 133 --------------------------------------- 2 files changed, 17 insertions(+), 174 deletions(-) delete mode 100644 doc/txt/Manual_build.txt diff --git a/doc/src/Manual_build.rst b/doc/src/Manual_build.rst index 2580ee6b93..a8bc093812 100644 --- a/doc/src/Manual_build.rst +++ b/doc/src/Manual_build.rst @@ -20,28 +20,20 @@ directories and files should be included. If you downloaded LAMMPS from the public SVN or Git repositories, then the HTML and PDF files are not included. Instead you need to create -them, in one of three ways: +them, in one of two ways: -(a) You can "fetch" the current HTML and PDF files from the LAMMPS web -site. Just type "make fetch". This should create a html\_www dir and -Manual\_www.pdf/Developer\_www.pdf files. Note that if new LAMMPS -features have been added more recently than the date of your version, -the fetched documentation will include those changes (but your source -code will not, unless you update your local repository). - -(b) You can build the HTML and PDF files yourself, by typing "make -html" followed by "make pdf". Note that the PDF make requires the -HTML files already exist. This requires various tools including -Sphinx, which the build process will attempt to download and install -on your system, if not already available. See more details below. - -(c) You can generate an older, simpler, less-fancy style of HTML -documentation by typing "make old". This will create an "old" -directory. This can be useful if (b) does not work on your box for -some reason, or you want to quickly view the HTML version of a doc -page you have created or edited yourself within the src directory. -E.g. if you are planning to submit a new feature to LAMMPS. +a. You can "fetch" the current HTML and PDF files from the LAMMPS web site. + Just type "make fetch". This should create a html\_www dir and + Manual\_www.pdf/Developer\_www.pdf files. Note that if new LAMMPS features + have been added more recently than the date of your version, the fetched + documentation will include those changes (but your source code will not, unless + you update your local repository). +b. You can build the HTML and PDF files yourself, by typing "make + html" followed by "make pdf". Note that the PDF make requires the + HTML files already exist. This requires various tools including + Sphinx, which the build process will attempt to download and install + on your system, if not already available. See more details below. ---------- @@ -50,14 +42,13 @@ The generation of all documentation is managed by the Makefile in the doc dir. -.. parsed-literal:: +.. code-block:: bash Documentation Build Options: make html # generate HTML in html dir using Sphinx make pdf # generate 2 PDF files (Manual.pdf,Developer.pdf) # in doc dir via htmldoc and pdflatex - make old # generate old-style HTML pages in old dir via txt2html make fetch # fetch HTML doc pages and 2 PDF files from web site # as a tarball and unpack into html dir and 2 PDFs make epub # generate LAMMPS.epub in ePUB format using Sphinx @@ -82,7 +73,7 @@ Ubuntu ------ -.. parsed-literal:: +.. code-block:: bash sudo apt-get install python-virtualenv @@ -90,7 +81,7 @@ Fedora (up to version 21) and Red Hat Enterprise Linux or CentOS (up to version ------------------------------------------------------------------------------------ -.. parsed-literal:: +.. code-block:: bash sudo yum install python3-virtualenv @@ -98,7 +89,7 @@ Fedora (since version 22) ------------------------- -.. parsed-literal:: +.. code-block:: bash sudo dnf install python3-virtualenv @@ -119,7 +110,7 @@ virtualenv Once Python 3 is installed, open a Terminal and type -.. parsed-literal:: +.. code-block:: bash pip3 install virtualenv @@ -129,21 +120,6 @@ This will install virtualenv from the Python Package Index. ---------- -Installing prerequisites for PDF build - -Building the PDF manual requires a working C++ compiler (to -compile the txt2html tool and a working installation of -`HTMLDOC `_ -HTMLDOC has its own list of prerequisites, but in most cases -you can install a binary package of it either through your -Linux package manager or MacOS (dmg) and Windows installer -(msi) packages from its -`GitHub releases page at `_ - - ----------- - - Installing prerequisites for epub build ======================================= diff --git a/doc/txt/Manual_build.txt b/doc/txt/Manual_build.txt deleted file mode 100644 index e9df0d2cfc..0000000000 --- a/doc/txt/Manual_build.txt +++ /dev/null @@ -1,133 +0,0 @@ -"Previous Section"_Errors.html - "LAMMPS WWW Site"_lws - -"LAMMPS Documentation"_ld - "LAMMPS Commands"_lc - "Next -Section"_Manual.html :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -Building the LAMMPS manual :h2 - -Depending on how you obtained LAMMPS, the doc directory has 2 or 3 -sub-directories and optionally 2 PDF files and 2 e-book format files: - -src # content files for LAMMPS documentation -html # HTML version of the LAMMPS manual (see html/Manual.html) -tools # tools and settings for building the documentation -Manual.pdf # large PDF version of entire manual -Developer.pdf # small PDF with info about how LAMMPS is structured -LAMMPS.epub # Manual in ePUB e-book format -LAMMPS.mobi # Manual in MOBI e-book format :pre - -If you downloaded LAMMPS as a tarball from the web site, all these -directories and files should be included. - -If you downloaded LAMMPS from the public SVN or Git repositories, then -the HTML and PDF files are not included. Instead you need to create -them, in one of three ways: - -(a) You can "fetch" the current HTML and PDF files from the LAMMPS web -site. Just type "make fetch". This should create a html_www dir and -Manual_www.pdf/Developer_www.pdf files. Note that if new LAMMPS -features have been added more recently than the date of your version, -the fetched documentation will include those changes (but your source -code will not, unless you update your local repository). - -(b) You can build the HTML and PDF files yourself, by typing "make -html" followed by "make pdf". Note that the PDF make requires the -HTML files already exist. This requires various tools including -Sphinx, which the build process will attempt to download and install -on your system, if not already available. See more details below. - -(c) You can generate an older, simpler, less-fancy style of HTML -documentation by typing "make old". This will create an "old" -directory. This can be useful if (b) does not work on your box for -some reason, or you want to quickly view the HTML version of a doc -page you have created or edited yourself within the src directory. -E.g. if you are planning to submit a new feature to LAMMPS. - -:line - -The generation of all documentation is managed by the Makefile in -the doc dir. - -Documentation Build Options: :pre - -make html # generate HTML in html dir using Sphinx -make pdf # generate 2 PDF files (Manual.pdf,Developer.pdf) - # in doc dir via htmldoc and pdflatex -make old # generate old-style HTML pages in old dir via txt2html -make fetch # fetch HTML doc pages and 2 PDF files from web site - # as a tarball and unpack into html dir and 2 PDFs -make epub # generate LAMMPS.epub in ePUB format using Sphinx -make mobi # generate LAMMPS.mobi in MOBI format using ebook-convert -make clean # remove intermediate RST files created by HTML build -make clean-all # remove entire build folder and any cached data :pre -make anchor_check # check for duplicate anchor labels -make spelling # spell-check the manual - -:line - -Installing prerequisites for HTML build :h3 - -To run the HTML documentation build toolchain, Python 3 and virtualenv -have to be installed. Here are instructions for common setups: - -Ubuntu :h4 - -sudo apt-get install python-virtualenv :pre - -Fedora (up to version 21) and Red Hat Enterprise Linux or CentOS (up to version 7.x) :h4 - -sudo yum install python3-virtualenv :pre - -Fedora (since version 22) :h4 - -sudo dnf install python3-virtualenv :pre - -MacOS X :h4 - -Python 3 :h5 - -Download the latest Python 3 MacOS X package from -"https://www.python.org"_https://www.python.org -and install it. This will install both Python 3 -and pip3. - -virtualenv :h5 - -Once Python 3 is installed, open a Terminal and type - -pip3 install virtualenv :pre - -This will install virtualenv from the Python Package Index. - -:line - -Installing prerequisites for PDF build - -Building the PDF manual requires a working C++ compiler (to -compile the txt2html tool and a working installation of -"HTMLDOC"_https://www.msweet.org/htmldoc/ -HTMLDOC has its own list of prerequisites, but in most cases -you can install a binary package of it either through your -Linux package manager or MacOS (dmg) and Windows installer -(msi) packages from its -"GitHub releases page at"_https://github.com/michaelrsweet/htmldoc/releases - -:line - -Installing prerequisites for epub build :h3 - -ePUB :h4 - -Same as for HTML. This uses the same tools and configuration -files as the HTML tree. - -For converting the generated ePUB file to a MOBI format file -(for e-book readers like Kindle, that cannot read ePUB), you -also need to have the 'ebook-convert' tool from the "calibre" -software installed. "http://calibre-ebook.com/"_http://calibre-ebook.com/ -You first create the ePUB file and then convert it with 'make mobi' From d2da55f5e3c17b876c97e67a9a1775532d01ac18 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 6 Nov 2019 23:52:04 -0500 Subject: [PATCH 351/557] Update Howto_pylammps.rst and remove Howto_pylammps.txt --- doc/src/Howto_pylammps.rst | 58 ++--- doc/txt/Howto_pylammps.txt | 481 ------------------------------------- 2 files changed, 29 insertions(+), 510 deletions(-) delete mode 100644 doc/txt/Howto_pylammps.txt diff --git a/doc/src/Howto_pylammps.rst b/doc/src/Howto_pylammps.rst index 98c14c547d..64f1cc6036 100644 --- a/doc/src/Howto_pylammps.rst +++ b/doc/src/Howto_pylammps.rst @@ -57,7 +57,7 @@ output support enabled. Step 1a: For the CMake based build system, the steps are: -.. parsed-literal:: +.. code-block:: bash mkdir $LAMMPS_DIR/build-shared cd $LAMMPS_DIR/build-shared @@ -69,7 +69,7 @@ Step 1a: For the CMake based build system, the steps are: Step 1b: For the legacy, make based build system, the steps are: -.. parsed-literal:: +.. code-block:: bash cd $LAMMPS_DIR/src @@ -86,7 +86,7 @@ PyLammps is part of the lammps Python package. To install it simply install that package into your current Python installation with: -.. parsed-literal:: +.. code-block:: bash make install-python @@ -111,7 +111,7 @@ Benefits of using a virtualenv **Prerequisite (e.g. on Ubuntu)** -.. parsed-literal:: +.. code-block:: bash apt-get install python-virtualenv @@ -119,7 +119,7 @@ Creating a virtualenv with lammps installed """"""""""""""""""""""""""""""""""""""""""" -.. parsed-literal:: +.. code-block:: bash # create virtualenv named 'testing' virtualenv $HOME/python/testing @@ -133,7 +133,7 @@ need to re-run CMake to update the location of the python executable to the location in the virtual environment with: -.. parsed-literal:: +.. code-block:: bash cmake . -DPYTHON_EXECUTABLE=$(which python) @@ -155,7 +155,7 @@ To create a PyLammps object you need to first import the class from the lammps module. By using the default constructor, a new *lammps* instance is created. -.. parsed-literal:: +.. code-block:: Python from lammps import PyLammps L = PyLammps() @@ -163,7 +163,7 @@ module. By using the default constructor, a new *lammps* instance is created. You can also initialize PyLammps on top of this existing *lammps* object: -.. parsed-literal:: +.. code-block:: Python from lammps import lammps, PyLammps lmp = lammps() @@ -178,7 +178,7 @@ the command method of the lammps object instance. For instance, let's take the following LAMMPS command: -.. parsed-literal:: +.. code-block:: LAMMPS region box block 0 10 0 5 -0.5 0.5 @@ -186,7 +186,7 @@ In the original interface this command can be executed with the following Python code if *L* was a lammps instance: -.. parsed-literal:: +.. code-block:: Python L.command("region box block 0 10 0 5 -0.5 0.5") @@ -194,7 +194,7 @@ With the PyLammps interface, any command can be split up into arbitrary parts separated by white-space, passed as individual arguments to a region method. -.. parsed-literal:: +.. code-block:: Python L.region("box block", 0, 10, 0, 5, -0.5, 0.5) @@ -207,7 +207,7 @@ parameterization. In the original interface parameterization needed to be done manually by creating formatted strings. -.. parsed-literal:: +.. code-block:: Python L.command("region box block %f %f %f %f %f %f" % (xlo, xhi, ylo, yhi, zlo, zhi)) @@ -215,7 +215,7 @@ In contrast, methods of PyLammps accept parameters directly and will convert them automatically to a final command string. -.. parsed-literal:: +.. code-block:: Python L.region("box block", xlo, xhi, ylo, yhi, zlo, zhi) @@ -270,7 +270,7 @@ LAMMPS variables can be both defined and accessed via the PyLammps interface. To define a variable you can use the :doc:`variable ` command: -.. parsed-literal:: +.. code-block:: Python L.variable("a index 2") @@ -280,7 +280,7 @@ you can access an individual variable by retrieving a variable object from the L.variables dictionary by name -.. parsed-literal:: +.. code-block:: Python a = L.variables['a'] @@ -288,7 +288,7 @@ The variable value can then be easily read and written by accessing the value property of this object. -.. parsed-literal:: +.. code-block:: Python print(a.value) a.value = 4 @@ -301,7 +301,7 @@ passed string parameter can be any expression containing global thermo values, variables, compute or fix data. -.. parsed-literal:: +.. code-block:: Python result = L.eval("ke") # kinetic energy result = L.eval("pe") # potential energy @@ -316,7 +316,7 @@ Each element of this list is an object which exposes its properties (id, type, position, velocity, force, etc.). -.. parsed-literal:: +.. code-block:: Python # access first atom L.atoms[0].id @@ -330,7 +330,7 @@ position, velocity, force, etc.). Some properties can also be used to set: -.. parsed-literal:: +.. code-block:: Python # set position in 2D simulation L.atoms[0].position = (1.0, 0.0) @@ -348,7 +348,7 @@ The first element is the output of the first run, the second element that of the second run. -.. parsed-literal:: +.. code-block:: Python L.run(1000) L.runs[0] # data of first 1000 time steps @@ -360,7 +360,7 @@ Each run contains a dictionary of all trajectories. Each trajectory is accessible through its thermo name: -.. parsed-literal:: +.. code-block:: Python L.runs[0].step # list of time steps in first run L.runs[0].ke # list of kinetic energy values in first run @@ -370,7 +370,7 @@ Together with matplotlib plotting data out of LAMMPS becomes simple: import matplotlib.plot as plt -.. parsed-literal:: +.. code-block:: Python steps = L.runs[0].step ke = L.runs[0].ke @@ -408,7 +408,7 @@ To launch an instance of Jupyter simply run the following command inside your Python environment (this assumes you followed the Quick Start instructions): -.. parsed-literal:: +.. code-block:: bash jupyter notebook @@ -431,7 +431,7 @@ them using a datafile. Then one of the atoms is rotated along the central axis b setting its position from Python, which changes the dihedral angle. -.. parsed-literal:: +.. code-block:: Python phi = [d \* math.pi / 180 for d in range(360)] @@ -465,7 +465,7 @@ Initially, a 2D system is created in a state with minimal energy. It is then disordered by moving each atom by a random delta. -.. parsed-literal:: +.. code-block:: Python random.seed(27848) deltaperturb = 0.2 @@ -485,7 +485,7 @@ Finally, the Monte Carlo algorithm is implemented in Python. It continuously moves random atoms by a random delta and only accepts certain moves. -.. parsed-literal:: +.. code-block:: Python estart = L.eval("pe") elast = estart @@ -538,7 +538,7 @@ Using PyLammps and mpi4py (Experimental) PyLammps can be run in parallel using mpi4py. This python package can be installed using -.. parsed-literal:: +.. code-block:: bash pip install mpi4py @@ -546,7 +546,7 @@ The following is a short example which reads in an existing LAMMPS input file an executes it in parallel. You can find in.melt in the examples/melt folder. -.. parsed-literal:: +.. code-block:: Python from mpi4py import MPI from lammps import PyLammps @@ -563,7 +563,7 @@ To run this script (melt.py) in parallel using 4 MPI processes we invoke the following mpirun command: -.. parsed-literal:: +.. code-block:: bash mpirun -np 4 python melt.py diff --git a/doc/txt/Howto_pylammps.txt b/doc/txt/Howto_pylammps.txt deleted file mode 100644 index 54f17d912a..0000000000 --- a/doc/txt/Howto_pylammps.txt +++ /dev/null @@ -1,481 +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 - -PyLammps Tutorial :h3 - - - -Overview :h4 - -PyLammps is a Python wrapper class which can be created on its own or -use an existing lammps Python object. It creates a simpler, -Python-like interface to common LAMMPS functionality, in contrast to -the lammps.py wrapper on the C-style LAMMPS library interface which is -written using Python ctypes. The lammps.py wrapper is discussed on -the "Python library"_Python_library.html doc page. - -Unlike the flat ctypes interface, PyLammps exposes a discoverable API. -It no longer requires knowledge of the underlying C++ code -implementation. Finally, the IPyLammps wrapper builds on top of -PyLammps and adds some additional features for IPython integration -into IPython notebooks, e.g. for embedded visualization output from -dump/image. - -Comparison of lammps and PyLammps interfaces :h5 - -lammps.lammps :h6 - -uses C-Types -direct memory access to native C++ data -provides functions to send and receive data to LAMMPS -requires knowledge of how LAMMPS internally works (C pointers, etc) :ul - -lammps.PyLammps :h6 - -higher-level abstraction built on top of original C-Types interface -manipulation of Python objects -communication with LAMMPS is hidden from API user -shorter, more concise Python -better IPython integration, designed for quick prototyping :ul - -Quick Start :h4 - -System-wide Installation :h5 - -Step 1: Building LAMMPS as a shared library :h6 - -To use LAMMPS inside of Python it has to be compiled as shared library. This -library is then loaded by the Python interface. In this example we enable the -MOLECULE package and compile LAMMPS with C++ exceptions, PNG, JPEG and FFMPEG -output support enabled. - -Step 1a: For the CMake based build system, the steps are: - -mkdir $LAMMPS_DIR/build-shared -cd $LAMMPS_DIR/build-shared :pre - -# MPI, PNG, Jpeg, FFMPEG are auto-detected -cmake ../cmake -DPKG_MOLECULE=yes -DLAMMPS_EXCEPTIONS=yes -DBUILD_LIB=yes -DBUILD_SHARED_LIBS=yes -make :pre - -Step 1b: For the legacy, make based build system, the steps are: - -cd $LAMMPS_DIR/src :pre - -# add packages if necessary -make yes-MOLECULE :pre - -# compile shared library using Makefile -make mpi mode=shlib LMP_INC="-DLAMMPS_PNG -DLAMMPS_JPEG -DLAMMPS_FFMPEG -DLAMMPS_EXCEPTIONS" JPG_LIB="-lpng -ljpeg" :pre - -Step 2: Installing the LAMMPS Python package :h6 - -PyLammps is part of the lammps Python package. To install it simply install -that package into your current Python installation with: - -make install-python :pre - -NOTE: Recompiling the shared library requires re-installing the Python package - - -Installation inside of a virtualenv :h5 - -You can use virtualenv to create a custom Python environment specifically tuned -for your workflow. - -Benefits of using a virtualenv :h6 - -isolation of your system Python installation from your development installation -installation can happen in your user directory without root access (useful for HPC clusters) -installing packages through pip allows you to get newer versions of packages than e.g., through apt-get or yum package managers (and without root access) -you can even install specific old versions of a package if necessary :ul - -[Prerequisite (e.g. on Ubuntu)] - -apt-get install python-virtualenv :pre - -Creating a virtualenv with lammps installed :h6 - -# create virtualenv named 'testing' -virtualenv $HOME/python/testing :pre - -# activate 'testing' environment -source $HOME/python/testing/bin/activate :pre - -Now configure and compile the LAMMPS shared library as outlined above. -When using CMake and the shared library has already been build, you -need to re-run CMake to update the location of the python executable -to the location in the virtual environment with: - -cmake . -DPYTHON_EXECUTABLE=$(which python) :pre - -# install LAMMPS package in virtualenv -(testing) make install-python :pre - -# install other useful packages -(testing) pip install matplotlib jupyter mpi4py :pre - -... :pre - -# return to original shell -(testing) deactivate :pre - - -Creating a new instance of PyLammps :h4 - -To create a PyLammps object you need to first import the class from the lammps -module. By using the default constructor, a new {lammps} instance is created. - -from lammps import PyLammps -L = PyLammps() :pre - -You can also initialize PyLammps on top of this existing {lammps} object: - -from lammps import lammps, PyLammps -lmp = lammps() -L = PyLammps(ptr=lmp) :pre - -Commands :h4 - -Sending a LAMMPS command with the existing library interfaces is done using -the command method of the lammps object instance. - -For instance, let's take the following LAMMPS command: - -region box block 0 10 0 5 -0.5 0.5 :pre - -In the original interface this command can be executed with the following -Python code if {L} was a lammps instance: - -L.command("region box block 0 10 0 5 -0.5 0.5") :pre - -With the PyLammps interface, any command can be split up into arbitrary parts -separated by white-space, passed as individual arguments to a region method. - -L.region("box block", 0, 10, 0, 5, -0.5, 0.5) :pre - -Note that each parameter is set as Python literal floating-point number. In the -PyLammps interface, each command takes an arbitrary parameter list and transparently -merges it to a single command string, separating individual parameters by white-space. - -The benefit of this approach is avoiding redundant command calls and easier -parameterization. In the original interface parameterization needed to be done -manually by creating formatted strings. - -L.command("region box block %f %f %f %f %f %f" % (xlo, xhi, ylo, yhi, zlo, zhi)) :pre - -In contrast, methods of PyLammps accept parameters directly and will convert -them automatically to a final command string. - -L.region("box block", xlo, xhi, ylo, yhi, zlo, zhi) :pre - -System state :h4 - -In addition to dispatching commands directly through the PyLammps object, it -also provides several properties which allow you to query the system state. - -:dlb - -L.system :dt - -Is a dictionary describing the system such as the bounding box or number of atoms :dd - -L.system.xlo, L.system.xhi :dt - -bounding box limits along x-axis :dd - -L.system.ylo, L.system.yhi :dt - -bounding box limits along y-axis :dd - -L.system.zlo, L.system.zhi :dt - -bounding box limits along z-axis :dd - -L.communication :dt - -configuration of communication subsystem, such as the number of threads or processors :dd - -L.communication.nthreads :dt - -number of threads used by each LAMMPS process :dd - -L.communication.nprocs :dt - -number of MPI processes used by LAMMPS :dd - -L.fixes :dt - -List of fixes in the current system :dd - -L.computes :dt - -List of active computes in the current system :dd - -L.dump :dt - -List of active dumps in the current system :dd - -L.groups :dt - -List of groups present in the current system :dd - -:dle - -Working with LAMMPS variables :h4 - -LAMMPS variables can be both defined and accessed via the PyLammps interface. - -To define a variable you can use the "variable"_variable.html command: - -L.variable("a index 2") :pre - -A dictionary of all variables is returned by L.variables - -you can access an individual variable by retrieving a variable object from the -L.variables dictionary by name - -a = L.variables\['a'\] :pre - -The variable value can then be easily read and written by accessing the value -property of this object. - -print(a.value) -a.value = 4 :pre - -Retrieving the value of an arbitrary LAMMPS expressions :h4 - -LAMMPS expressions can be immediately evaluated by using the eval method. The -passed string parameter can be any expression containing global thermo values, -variables, compute or fix data. - -result = L.eval("ke") # kinetic energy -result = L.eval("pe") # potential energy :pre - -result = L.eval("v_t/2.0") :pre - -Accessing atom data :h4 - -All atoms in the current simulation can be accessed by using the L.atoms list. -Each element of this list is an object which exposes its properties (id, type, -position, velocity, force, etc.). - -# access first atom -L.atoms\[0\].id -L.atoms\[0\].type :pre - -# access second atom -L.atoms\[1\].position -L.atoms\[1\].velocity -L.atoms\[1\].force :pre - -Some properties can also be used to set: - -# set position in 2D simulation -L.atoms\[0\].position = (1.0, 0.0) :pre - -# set position in 3D simulation -L.atoms\[0\].position = (1.0, 0.0, 1.) :pre - -Evaluating thermo data :h4 - -Each simulation run usually produces thermo output based on system state, -computes, fixes or variables. The trajectories of these values can be queried -after a run via the L.runs list. This list contains a growing list of run data. -The first element is the output of the first run, the second element that of -the second run. - -L.run(1000) -L.runs\[0\] # data of first 1000 time steps :pre - -L.run(1000) -L.runs\[1\] # data of second 1000 time steps :pre - -Each run contains a dictionary of all trajectories. Each trajectory is -accessible through its thermo name: - -L.runs\[0\].step # list of time steps in first run -L.runs\[0\].ke # list of kinetic energy values in first run :pre - -Together with matplotlib plotting data out of LAMMPS becomes simple: - -import matplotlib.plot as plt - -steps = L.runs\[0\].step -ke = L.runs\[0\].ke -plt.plot(steps, ke) :pre - -Error handling with PyLammps :h4 - -Compiling the shared library with C++ exception support provides a better error -handling experience. Without exceptions the LAMMPS code will terminate the -current Python process with an error message. C++ exceptions allow capturing -them on the C++ side and rethrowing them on the Python side. This way you -can handle LAMMPS errors through the Python exception handling mechanism. - -IMPORTANT NOTE: Capturing a LAMMPS exception in Python can still mean that the -current LAMMPS process is in an illegal state and must be terminated. It is -advised to save your data and terminate the Python instance as quickly as -possible. - -Using PyLammps in IPython notebooks and Jupyter :h4 - -If the LAMMPS Python package is installed for the same Python interpreter as -IPython, you can use PyLammps directly inside of an IPython notebook inside of -Jupyter. Jupyter is a powerful integrated development environment (IDE) for -many dynamic languages like Python, Julia and others, which operates inside of -any web browser. Besides auto-completion and syntax highlighting it allows you -to create formatted documents using Markup, mathematical formulas, graphics and -animations intermixed with executable Python code. It is a great format for -tutorials and showcasing your latest research. - -To launch an instance of Jupyter simply run the following command inside your -Python environment (this assumes you followed the Quick Start instructions): - -jupyter notebook :pre - -IPyLammps Examples :h4 - -Examples of IPython notebooks can be found in the python/examples/pylammps -sub-directory. To open these notebooks launch {jupyter notebook} inside this -directory and navigate to one of them. If you compiled and installed -a LAMMPS shared library with exceptions, PNG, JPEG and FFMPEG support -you should be able to rerun all of these notebooks. - -Validating a dihedral potential :h5 - -This example showcases how an IPython Notebook can be used to compare a simple -LAMMPS simulation of a harmonic dihedral potential to its analytical solution. -Four atoms are placed in the simulation and the dihedral potential is applied on -them using a datafile. Then one of the atoms is rotated along the central axis by -setting its position from Python, which changes the dihedral angle. - -phi = \[d * math.pi / 180 for d in range(360)\] :pre - -pos = \[(1.0, math.cos(p), math.sin(p)) for p in phi\] :pre - -pe = \[\] -for p in pos: - L.atoms\[3\].position = p - L.run(0) - pe.append(L.eval("pe")) :pre - -By evaluating the potential energy for each position we can verify that -trajectory with the analytical formula. To compare both solutions, we plot -both trajectories over each other using matplotlib, which embeds the generated -plot inside the IPython notebook. - -:c,image(JPG/pylammps_dihedral.jpg) - -Running a Monte Carlo relaxation :h5 - -This second example shows how to use PyLammps to create a 2D Monte Carlo Relaxation -simulation, computing and plotting energy terms and even embedding video output. - -Initially, a 2D system is created in a state with minimal energy. - -:c,image(JPG/pylammps_mc_minimum.jpg) - -It is then disordered by moving each atom by a random delta. - -random.seed(27848) -deltaperturb = 0.2 :pre - -for i in range(L.system.natoms): - x, y = L.atoms\[i\].position - dx = deltaperturb * random.uniform(-1, 1) - dy = deltaperturb * random.uniform(-1, 1) - L.atoms\[i\].position = (x+dx, y+dy) :pre - -L.run(0) :pre - -:c,image(JPG/pylammps_mc_disordered.jpg) - -Finally, the Monte Carlo algorithm is implemented in Python. It continuously -moves random atoms by a random delta and only accepts certain moves. - -estart = L.eval("pe") -elast = estart :pre - -naccept = 0 -energies = \[estart\] :pre - -niterations = 3000 -deltamove = 0.1 -kT = 0.05 :pre - -natoms = L.system.natoms :pre - -for i in range(niterations): - iatom = random.randrange(0, natoms) - current_atom = L.atoms\[iatom\] :pre - - x0, y0 = current_atom.position :pre - - dx = deltamove * random.uniform(-1, 1) - dy = deltamove * random.uniform(-1, 1) :pre - - current_atom.position = (x0+dx, y0+dy) :pre - - L.run(1, "pre no post no") :pre - - e = L.eval("pe") - energies.append(e) :pre - - if e <= elast: - naccept += 1 - elast = e - elif random.random() <= math.exp(natoms*(elast-e)/kT): - naccept += 1 - elast = e - else: - current_atom.position = (x0, y0) :pre - -The energies of each iteration are collected in a Python list and finally plotted using matplotlib. - -:c,image(JPG/pylammps_mc_energies_plot.jpg) - -The IPython notebook also shows how to use dump commands and embed video files -inside of the IPython notebook. - -Using PyLammps and mpi4py (Experimental) :h4 - -PyLammps can be run in parallel using mpi4py. This python package can be installed using - -pip install mpi4py :pre - -The following is a short example which reads in an existing LAMMPS input file and -executes it in parallel. You can find in.melt in the examples/melt folder. - -from mpi4py import MPI -from lammps import PyLammps :pre - -L = PyLammps() -L.file("in.melt") :pre - -if MPI.COMM_WORLD.rank == 0: - print("Potential energy: ", L.eval("pe")) :pre - -MPI.Finalize() :pre - -To run this script (melt.py) in parallel using 4 MPI processes we invoke the -following mpirun command: - -mpirun -np 4 python melt.py :pre - -IMPORTANT NOTE: Any command must be executed by all MPI processes. However, evaluations and querying the system state is only available on rank 0. - -Feedback and Contributing :h4 - -If you find this Python interface useful, please feel free to provide feedback -and ideas on how to improve it to Richard Berger (richard.berger@temple.edu). We also -want to encourage people to write tutorial style IPython notebooks showcasing LAMMPS usage -and maybe their latest research results. From e5dd154366dbb7649640559eef8193e3cef92601 Mon Sep 17 00:00:00 2001 From: Jared Wood Date: Mon, 14 Oct 2019 11:13:58 +1100 Subject: [PATCH 352/557] Make max/min prevent moves already outside the bounds Previously allowed free movement outside the bounds until they were reached. Now forces movement towards the bounds --- src/MC/fix_gcmc.cpp | 18 +++++++++--------- 1 file changed, 9 insertions(+), 9 deletions(-) diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 818ed01fba..516fe2521d 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -269,7 +269,7 @@ void FixGCMC::options(int narg, char **arg) overlap_cutoffsq = 0.0; overlap_flag = 0; min_ngas = -1; - max_ngas = -1; + max_ngas = INT_MAX; int iarg = 0; while (iarg < narg) { @@ -903,7 +903,7 @@ void FixGCMC::attempt_atomic_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0 || ngas == min_ngas) return; + if (ngas == 0 || ngas <= min_ngas) return; int i = pick_random_gas_atom(); @@ -944,7 +944,7 @@ void FixGCMC::attempt_atomic_insertion() ninsertion_attempts += 1.0; - if (ngas == max_ngas) return; + if (ngas >= max_ngas) return; // pick coordinates for insertion point @@ -1260,7 +1260,7 @@ void FixGCMC::attempt_molecule_deletion() { ndeletion_attempts += 1.0; - if (ngas == 0 || ngas == min_ngas) return; + if (ngas == 0 || ngas <= min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -1299,7 +1299,7 @@ void FixGCMC::attempt_molecule_insertion() double lamda[3]; ninsertion_attempts += 1.0; - if (ngas == max_ngas) return; + if (ngas >= max_ngas) return; double com_coord[3]; if (regionflag) { @@ -1584,7 +1584,7 @@ void FixGCMC::attempt_atomic_deletion_full() ndeletion_attempts += 1.0; - if (ngas == 0 || ngas == min_ngas) return; + if (ngas == 0 || ngas <= min_ngas) return; double energy_before = energy_stored; @@ -1633,7 +1633,7 @@ void FixGCMC::attempt_atomic_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; - if (ngas == max_ngas) return; + if (ngas >= max_ngas) return; double energy_before = energy_stored; @@ -1930,7 +1930,7 @@ void FixGCMC::attempt_molecule_deletion_full() { ndeletion_attempts += 1.0; - if (ngas == 0 || ngas == min_ngas) return; + if (ngas == 0 || ngas <= min_ngas) return; // work-around to avoid n=0 problem with fix rigid/nvt/small @@ -2013,7 +2013,7 @@ void FixGCMC::attempt_molecule_insertion_full() double lamda[3]; ninsertion_attempts += 1.0; - if (ngas == max_ngas) return; + if (ngas >= max_ngas) return; double energy_before = energy_stored; From a2eec80f259d615567538f84b86d916eae5bacfc Mon Sep 17 00:00:00 2001 From: Jared Wood Date: Tue, 5 Nov 2019 16:32:35 +1100 Subject: [PATCH 353/557] add max and min to documentation --- doc/src/fix_gcmc.txt | 10 +++++++++- 1 file changed, 9 insertions(+), 1 deletion(-) diff --git a/doc/src/fix_gcmc.txt b/doc/src/fix_gcmc.txt index 3c0f2c2f17..f28cb5771f 100644 --- a/doc/src/fix_gcmc.txt +++ b/doc/src/fix_gcmc.txt @@ -48,7 +48,9 @@ keyword = {mol}, {region}, {maxangle}, {pressure}, {fugacity_coeff}, {full_energ group-ID = group-ID for inserted atoms (string) {intra_energy} value = intramolecular energy (energy units) {tfac_insert} value = scale up/down temperature of inserted atoms (unitless) - {overlap_cutoff} value = maximum pair distance for overlap rejection (distance units) :pre + {overlap_cutoff} value = maximum pair distance for overlap rejection (distance units) + {max} value = Maximum number of molecules allowed in the system + {min} value = Minimum number of molecules allowed in the system :pre :ule [Examples:] @@ -364,6 +366,12 @@ assigning an infinite positive energy to all new configurations that place any pair of atoms closer than the specified overlap cutoff distance. +The {max} and {min} keywords allow for the restriction of the number +of atoms in the simulation. They automatically reject all insertion +or deletion moves that would take the system beyond the set boundaries. +Should the system already be beyond the boundary, only moves that bring +the system closer to the bounds may be accepted. + The {group} keyword adds all inserted atoms to the "group"_group.html of the group-ID value. The {grouptype} keyword adds all inserted atoms of the specified type to the From d37ee59296576c89994350a61c9b81be658d8ae9 Mon Sep 17 00:00:00 2001 From: Jared Wood Date: Thu, 7 Nov 2019 09:24:01 +1100 Subject: [PATCH 354/557] Add example of fix gcmc max behaviour --- examples/gcmc/in.gcmc.lj.max | 70 ++++++++++++++++++++++++++++++++++++ 1 file changed, 70 insertions(+) create mode 100644 examples/gcmc/in.gcmc.lj.max diff --git a/examples/gcmc/in.gcmc.lj.max b/examples/gcmc/in.gcmc.lj.max new file mode 100644 index 0000000000..519ac162fa --- /dev/null +++ b/examples/gcmc/in.gcmc.lj.max @@ -0,0 +1,70 @@ +# GCMC for LJ simple fluid, no dynamics +# T = 2.0 +# rho ~ 0.5 +# p ~ 1.5 +# mu_ex ~ 0.0 +# comparable to Frenkel and Smit GCMC Case Study, Figure 5.8 + +# variables modifiable using -var command line switch + +variable mu index -1.25 +variable temp index 2.0 +variable disp index 1.0 +variable lbox index 5.0 + +# global model settings + +units lj +atom_style atomic +pair_style lj/cut 3.0 +pair_modify tail no # turn of to avoid triggering full_energy + +# box + +region box block 0 ${lbox} 0 ${lbox} 0 ${lbox} +create_box 1 box + +# lj parameters + +pair_coeff * * 1.0 1.0 +mass * 1.0 + +# we recommend setting up a dedicated group for gcmc + +group gcmcgroup type 1 + +# gcmc + +fix mygcmc gcmcgroup gcmc 1 100 100 1 29494 ${temp} ${mu} ${disp} max 50 + +# atom count + +variable type1 atom "type==1" +group type1 dynamic gcmcgroup var type1 +variable n1 equal count(type1) + +# averaging + +variable rho equal density +variable p equal press +variable nugget equal 1.0e-8 +variable lambda equal 1.0 +variable muex equal ${mu}-${temp}*ln(density*${lambda}+${nugget}) +fix ave all ave/time 10 100 1000 v_rho v_p v_muex v_n1 ave one file rho_vs_p.dat +variable rhoav equal f_ave[1] +variable pav equal f_ave[2] +variable muexav equal f_ave[3] +variable n1av equal f_ave[4] + +# output + +variable tacc equal f_mygcmc[2]/(f_mygcmc[1]+${nugget}) +variable iacc equal f_mygcmc[4]/(f_mygcmc[3]+${nugget}) +variable dacc equal f_mygcmc[6]/(f_mygcmc[5]+${nugget}) +compute_modify thermo_temp dynamic yes +thermo_style custom step temp press pe ke density atoms v_iacc v_dacc v_tacc v_rhoav v_pav v_muexav v_n1av +thermo 1000 + +# run + +run 10000 From c5b0f0afcfe38e0e6dc400f277fbe0632a60923e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Thu, 7 Nov 2019 17:06:38 -0700 Subject: [PATCH 355/557] add documention to FixPour::outside(), simplify logic a bit --- src/GRANULAR/fix_pour.cpp | 38 +++++++++++++++++++++++--------------- 1 file changed, 23 insertions(+), 15 deletions(-) diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 41bc3c93d5..2b33b988b8 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -54,7 +54,8 @@ FixPour::FixPour(LAMMPS *lmp, int narg, char **arg) : { if (narg < 6) error->all(FLERR,"Illegal fix pour command"); - if (lmp->kokkos) error->all(FLERR,"Cannot yet use fix pour with the KOKKOS package"); + if (lmp->kokkos) + error->all(FLERR,"Cannot yet use fix pour with the KOKKOS package"); time_depend = 1; @@ -789,23 +790,30 @@ bool FixPour::outside(int dim, double value, double lo, double hi) { double boxlo = domain->boxlo[dim]; double boxhi = domain->boxhi[dim]; - bool outside_pbc_range = true; - bool outside_regular_range = (value < lo || value > hi); - if (domain->periodicity[dim]) { - if ((lo < boxlo && hi > boxhi) || (hi - lo) > domain->prd[dim]) { - // value is always inside - outside_pbc_range = false; - } else if (lo < boxlo) { - // lower boundary crosses periodic boundary - outside_pbc_range = (value > hi && value < lo + domain->prd[dim]); - } else if (hi > boxhi) { - // upper boundary crosses periodic boundary - outside_pbc_range = (value < lo && value > hi - domain->prd[dim]); - } + // check for value inside/outside range, ignoring periodicity + // if inside or dim is non-periodic, only this test is needed + + bool outside_range = (value < lo || value > hi); + if (!outside_range || !domain->periodicity[dim]) return outside_range; + + // for periodic dimension: + // must perform additional tests if range wraps around the periodic box + + bool outside_pbc_range = true; + + if ((lo < boxlo && hi > boxhi) || (hi - lo) > domain->prd[dim]) { + // value is always inside + outside_pbc_range = false; + } else if (lo < boxlo) { + // lower boundary crosses periodic boundary + outside_pbc_range = (value > hi && value < lo + domain->prd[dim]); + } else if (hi > boxhi) { + // upper boundary crosses periodic boundary + outside_pbc_range = (value < lo && value > hi - domain->prd[dim]); } - return (outside_pbc_range && outside_regular_range); + return outside_pbc_range; } /* ---------------------------------------------------------------------- */ From ce6893e7175f838efa22f8ed77a21880855ac444 Mon Sep 17 00:00:00 2001 From: Jared Wood Date: Fri, 8 Nov 2019 12:59:39 +1100 Subject: [PATCH 356/557] Add max/min changes to documentation again --- doc/src/fix_gcmc.rst | 8 ++++++++ 1 file changed, 8 insertions(+) diff --git a/doc/src/fix_gcmc.rst b/doc/src/fix_gcmc.rst index 0bb59d3afc..9f64be8699 100644 --- a/doc/src/fix_gcmc.rst +++ b/doc/src/fix_gcmc.rst @@ -51,6 +51,8 @@ Syntax *intra_energy* value = intramolecular energy (energy units) *tfac_insert* value = scale up/down temperature of inserted atoms (unitless) *overlap_cutoff* value = maximum pair distance for overlap rejection (distance units) + *max* value = Maximum number of molecules allowed in the system + *min* value = Minimum number of molecules allowed in the system @@ -385,6 +387,12 @@ assigning an infinite positive energy to all new configurations that place any pair of atoms closer than the specified overlap cutoff distance. +The *max* and *min* keywords allow for the restriction of the number +of atoms in the simulation. They automatically reject all insertion +or deletion moves that would take the system beyond the set boundaries. +Should the system already be beyond the boundary, only moves that bring +the system closer to the bounds may be accepted. + The *group* keyword adds all inserted atoms to the :doc:`group ` of the group-ID value. The *grouptype* keyword adds all inserted atoms of the specified type to the From 83f0eb0058dbd39974dc9166c707cc0bbd4e72fd Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 7 Nov 2019 21:47:02 -0500 Subject: [PATCH 357/557] Remove unnecessary files --- doc/txt/computes.txt | 137 ------------------------------------------ doc/txt/impropers.txt | 23 ------- 2 files changed, 160 deletions(-) delete mode 100644 doc/txt/computes.txt delete mode 100644 doc/txt/impropers.txt diff --git a/doc/txt/computes.txt b/doc/txt/computes.txt deleted file mode 100644 index b24387e856..0000000000 --- a/doc/txt/computes.txt +++ /dev/null @@ -1,137 +0,0 @@ -Computes :h1 - - diff --git a/doc/txt/impropers.txt b/doc/txt/impropers.txt deleted file mode 100644 index ce829197fe..0000000000 --- a/doc/txt/impropers.txt +++ /dev/null @@ -1,23 +0,0 @@ -Improper Styles :h1 - - From 81e92de83875a1b79551924d2ba9d7f9e5b3d5f9 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 7 Nov 2019 21:47:29 -0500 Subject: [PATCH 358/557] Fix doc Makefile --- doc/Makefile | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/Makefile b/doc/Makefile index 5dcb070f4f..eceae88da6 100644 --- a/doc/Makefile +++ b/doc/Makefile @@ -168,7 +168,7 @@ anchor_check : $(ANCHORCHECK) # ------------------------------------------ -$(RSTDIR)/%.rst : src/%.txt $(TXT2RST) +$(RSTDIR)/%.rst : $(TXTDIR)/%.txt $(TXT2RST) @(\ mkdir -p $(RSTDIR) ; \ . $(VENV)/bin/activate ;\ From 02a1ef06306f4f6f6b02088725ca6a6f3e0a235c Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Nov 2019 09:25:08 -0700 Subject: [PATCH 359/557] add compute hma to list of computes --- doc/src/Commands_compute.rst | 68 ------------------------------------ doc/txt/Commands_compute.txt | 1 + 2 files changed, 1 insertion(+), 68 deletions(-) delete mode 100644 doc/src/Commands_compute.rst diff --git a/doc/src/Commands_compute.rst b/doc/src/Commands_compute.rst deleted file mode 100644 index 0a155965ef..0000000000 --- a/doc/src/Commands_compute.rst +++ /dev/null @@ -1,68 +0,0 @@ -+----------------------------------------+------------------------------------+------------------------------------------+ -| :doc:`General commands ` | :doc:`Fix styles ` | :doc:`Compute styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ -| :doc:`Pair styles ` | :doc:`Bond styles ` | :ref:`Angle styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ -| :ref:`Dihedral styles ` | :ref:`Improper styles ` | :doc:`KSpace styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ - -Compute commands -================ - -An alphabetic list of all LAMMPS :doc:`compute ` commands. -Some styles have accelerated versions. This is indicated by -additional letters in parenthesis: g = GPU, i = USER-INTEL, k = -KOKKOS, o = USER-OMP, t = OPT. - -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`chunk/atom ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | :doc:`com/chunk ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | :doc:`dilatation/atom ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | :doc:`entropy/atom ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | :doc:`fep ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | :doc:`gyration/chunk ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`gyration/shape ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | :doc:`improper ` | :doc:`improper/local ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | :doc:`ke/atom/eff ` | :doc:`ke/eff ` | :doc:`ke/rigid ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | :doc:`momentum ` | :doc:`msd ` | :doc:`msd/chunk ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | :doc:`pair ` | :doc:`pair/local ` | :doc:`pe ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | :doc:`plasticity/atom ` | :doc:`pressure ` | :doc:`pressure/cylinder ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | :doc:`property/local ` | :doc:`ptm/atom ` | :doc:`rdf ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | :doc:`rigid/local ` | :doc:`saed ` | :doc:`slice ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | :doc:`smd/internal/energy ` | :doc:`smd/plastic/strain ` | :doc:`smd/plastic/strain/rate ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | :doc:`smd/tlsph/num/neighs ` | :doc:`smd/tlsph/shape ` | :doc:`smd/tlsph/strain ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | :doc:`smd/ulsph/num/neighs ` | :doc:`smd/ulsph/strain ` | :doc:`smd/ulsph/strain/rate ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | :doc:`snad/atom ` | :doc:`snav/atom ` | :doc:`spin ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | :doc:`stress/tally ` | :doc:`tdpd/cc/atom ` | :doc:`temp (k) ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | :doc:`temp/com ` | :doc:`temp/cs ` | :doc:`temp/deform ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | :doc:`temp/partial ` | :doc:`temp/profile ` | :doc:`temp/ramp ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | :doc:`temp/sphere ` | :doc:`temp/uef ` | :doc:`ti ` | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ -| :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | :doc:`voronoi/atom ` | :doc:`xrd ` | | -+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+ - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/Commands_compute.txt b/doc/txt/Commands_compute.txt index e035eb8431..f9ef9d1dec 100644 --- a/doc/txt/Commands_compute.txt +++ b/doc/txt/Commands_compute.txt @@ -70,6 +70,7 @@ KOKKOS, o = USER-OMP, t = OPT. "heat/flux"_compute_heat_flux.html, "heat/flux/tally"_compute_tally.html, "hexorder/atom"_compute_hexorder_atom.html, +"hma"_compute_hma.html, "improper"_compute_improper.html, "improper/local"_compute_improper_local.html, "inertia/chunk"_compute_inertia_chunk.html, From 0583fb6ae03386f89d500ddb5b7b7d5add97a66e Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Fri, 8 Nov 2019 09:46:49 -0700 Subject: [PATCH 360/557] update rst file also --- doc/src/Commands_compute.rst | 68 ++++++++++++++++++++++++++++++++++++ 1 file changed, 68 insertions(+) create mode 100644 doc/src/Commands_compute.rst diff --git a/doc/src/Commands_compute.rst b/doc/src/Commands_compute.rst new file mode 100644 index 0000000000..63926b6d61 --- /dev/null +++ b/doc/src/Commands_compute.rst @@ -0,0 +1,68 @@ ++----------------------------------------+------------------------------------+------------------------------------------+ +| :doc:`General commands ` | :doc:`Fix styles ` | :doc:`Compute styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ +| :doc:`Pair styles ` | :doc:`Bond styles ` | :ref:`Angle styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ +| :ref:`Dihedral styles ` | :ref:`Improper styles ` | :doc:`KSpace styles ` | ++----------------------------------------+------------------------------------+------------------------------------------+ + +Compute commands +================ + +An alphabetic list of all LAMMPS :doc:`compute ` commands. +Some styles have accelerated versions. This is indicated by +additional letters in parenthesis: g = GPU, i = USER-INTEL, k = +KOKKOS, o = USER-OMP, t = OPT. + ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`chunk/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | :doc:`com/chunk ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | :doc:`dilatation/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | :doc:`entropy/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | :doc:`fep ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | :doc:`gyration/chunk ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`gyration/shape ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | :doc:`hma ` | :doc:`improper ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`improper/local ` | :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | :doc:`ke/atom/eff ` | :doc:`ke/eff ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`ke/rigid ` | :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | :doc:`momentum ` | :doc:`msd ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`msd/chunk ` | :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | :doc:`pair ` | :doc:`pair/local ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`pe ` | :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | :doc:`plasticity/atom ` | :doc:`pressure ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`pressure/cylinder ` | :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | :doc:`property/local ` | :doc:`ptm/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`rdf ` | :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | :doc:`rigid/local ` | :doc:`saed ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`slice ` | :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | :doc:`smd/internal/energy ` | :doc:`smd/plastic/strain ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`smd/plastic/strain/rate ` | :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | :doc:`smd/tlsph/num/neighs ` | :doc:`smd/tlsph/shape ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`smd/tlsph/strain ` | :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | :doc:`smd/ulsph/num/neighs ` | :doc:`smd/ulsph/strain ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`smd/ulsph/strain/rate ` | :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | :doc:`snad/atom ` | :doc:`snav/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`spin ` | :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | :doc:`stress/tally ` | :doc:`tdpd/cc/atom ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`temp (k) ` | :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | :doc:`temp/com ` | :doc:`temp/cs ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`temp/deform ` | :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | :doc:`temp/partial ` | :doc:`temp/profile ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`temp/ramp ` | :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | :doc:`temp/sphere ` | :doc:`temp/uef ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ +| :doc:`ti ` | :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | :doc:`voronoi/atom ` | :doc:`xrd ` | ++------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html From 6623169d97b731e4d672152b10afd3e2b3ef1fca Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 8 Nov 2019 15:00:26 -0500 Subject: [PATCH 361/557] Delete example file on request of @athomps --- examples/gcmc/in.gcmc.lj.max | 70 ------------------------------------ 1 file changed, 70 deletions(-) delete mode 100644 examples/gcmc/in.gcmc.lj.max diff --git a/examples/gcmc/in.gcmc.lj.max b/examples/gcmc/in.gcmc.lj.max deleted file mode 100644 index 519ac162fa..0000000000 --- a/examples/gcmc/in.gcmc.lj.max +++ /dev/null @@ -1,70 +0,0 @@ -# GCMC for LJ simple fluid, no dynamics -# T = 2.0 -# rho ~ 0.5 -# p ~ 1.5 -# mu_ex ~ 0.0 -# comparable to Frenkel and Smit GCMC Case Study, Figure 5.8 - -# variables modifiable using -var command line switch - -variable mu index -1.25 -variable temp index 2.0 -variable disp index 1.0 -variable lbox index 5.0 - -# global model settings - -units lj -atom_style atomic -pair_style lj/cut 3.0 -pair_modify tail no # turn of to avoid triggering full_energy - -# box - -region box block 0 ${lbox} 0 ${lbox} 0 ${lbox} -create_box 1 box - -# lj parameters - -pair_coeff * * 1.0 1.0 -mass * 1.0 - -# we recommend setting up a dedicated group for gcmc - -group gcmcgroup type 1 - -# gcmc - -fix mygcmc gcmcgroup gcmc 1 100 100 1 29494 ${temp} ${mu} ${disp} max 50 - -# atom count - -variable type1 atom "type==1" -group type1 dynamic gcmcgroup var type1 -variable n1 equal count(type1) - -# averaging - -variable rho equal density -variable p equal press -variable nugget equal 1.0e-8 -variable lambda equal 1.0 -variable muex equal ${mu}-${temp}*ln(density*${lambda}+${nugget}) -fix ave all ave/time 10 100 1000 v_rho v_p v_muex v_n1 ave one file rho_vs_p.dat -variable rhoav equal f_ave[1] -variable pav equal f_ave[2] -variable muexav equal f_ave[3] -variable n1av equal f_ave[4] - -# output - -variable tacc equal f_mygcmc[2]/(f_mygcmc[1]+${nugget}) -variable iacc equal f_mygcmc[4]/(f_mygcmc[3]+${nugget}) -variable dacc equal f_mygcmc[6]/(f_mygcmc[5]+${nugget}) -compute_modify thermo_temp dynamic yes -thermo_style custom step temp press pe ke density atoms v_iacc v_dacc v_tacc v_rhoav v_pav v_muexav v_n1av -thermo 1000 - -# run - -run 10000 From b9648884bbedacb43cd8ea738be84d64e1927be7 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 8 Nov 2019 15:28:12 -0500 Subject: [PATCH 362/557] Add rst versions of new documentation --- doc/src/Commands_compute.rst | 96 +++++++++++++++--------------- doc/src/compute.rst | 3 +- doc/src/compute_gyration_shape.rst | 20 ++++--- 3 files changed, 62 insertions(+), 57 deletions(-) diff --git a/doc/src/Commands_compute.rst b/doc/src/Commands_compute.rst index 63926b6d61..351eca3709 100644 --- a/doc/src/Commands_compute.rst +++ b/doc/src/Commands_compute.rst @@ -14,53 +14,55 @@ Some styles have accelerated versions. This is indicated by additional letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = OPT. -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`chunk/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | :doc:`com/chunk ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | :doc:`dilatation/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | :doc:`entropy/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | :doc:`fep ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | :doc:`gyration/chunk ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`gyration/shape ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | :doc:`hma ` | :doc:`improper ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`improper/local ` | :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | :doc:`ke/atom/eff ` | :doc:`ke/eff ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`ke/rigid ` | :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | :doc:`momentum ` | :doc:`msd ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`msd/chunk ` | :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | :doc:`pair ` | :doc:`pair/local ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`pe ` | :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | :doc:`plasticity/atom ` | :doc:`pressure ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`pressure/cylinder ` | :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | :doc:`property/local ` | :doc:`ptm/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`rdf ` | :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | :doc:`rigid/local ` | :doc:`saed ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`slice ` | :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | :doc:`smd/internal/energy ` | :doc:`smd/plastic/strain ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`smd/plastic/strain/rate ` | :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | :doc:`smd/tlsph/num/neighs ` | :doc:`smd/tlsph/shape ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`smd/tlsph/strain ` | :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | :doc:`smd/ulsph/num/neighs ` | :doc:`smd/ulsph/strain ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`smd/ulsph/strain/rate ` | :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | :doc:`snad/atom ` | :doc:`snav/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`spin ` | :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | :doc:`stress/tally ` | :doc:`tdpd/cc/atom ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`temp (k) ` | :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | :doc:`temp/com ` | :doc:`temp/cs ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`temp/deform ` | :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | :doc:`temp/partial ` | :doc:`temp/profile ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`temp/ramp ` | :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | :doc:`temp/sphere ` | :doc:`temp/uef ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ -| :doc:`ti ` | :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | :doc:`voronoi/atom ` | :doc:`xrd ` | -+------------------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+--------------------------------------------------------+ ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`chunk/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | :doc:`com/chunk ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | :doc:`dilatation/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | :doc:`entropy/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | :doc:`fep ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | :doc:`gyration/chunk ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`gyration/shape ` | :doc:`gyration/shape/chunk ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | :doc:`hma ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`improper ` | :doc:`improper/local ` | :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | :doc:`ke/atom/eff ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`ke/eff ` | :doc:`ke/rigid ` | :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | :doc:`momentum ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`msd ` | :doc:`msd/chunk ` | :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | :doc:`pair ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`pair/local ` | :doc:`pe ` | :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | :doc:`plasticity/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`pressure ` | :doc:`pressure/cylinder ` | :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | :doc:`property/local ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`ptm/atom ` | :doc:`rdf ` | :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | :doc:`rigid/local ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`saed ` | :doc:`slice ` | :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | :doc:`smd/internal/energy ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`smd/plastic/strain ` | :doc:`smd/plastic/strain/rate ` | :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | :doc:`smd/tlsph/num/neighs ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`smd/tlsph/shape ` | :doc:`smd/tlsph/strain ` | :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | :doc:`smd/ulsph/num/neighs ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`smd/ulsph/strain ` | :doc:`smd/ulsph/strain/rate ` | :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | :doc:`snad/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`snav/atom ` | :doc:`spin ` | :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | :doc:`stress/tally ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`tdpd/cc/atom ` | :doc:`temp (k) ` | :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | :doc:`temp/com ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`temp/cs ` | :doc:`temp/deform ` | :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | :doc:`temp/partial ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`temp/profile ` | :doc:`temp/ramp ` | :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | :doc:`temp/sphere ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`temp/uef ` | :doc:`ti ` | :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | :doc:`voronoi/atom ` | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ +| :doc:`xrd ` | | | | | | ++--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ .. _lws: http://lammps.sandia.gov diff --git a/doc/src/compute.rst b/doc/src/compute.rst index f95e8a3f32..419352a9ac 100644 --- a/doc/src/compute.rst +++ b/doc/src/compute.rst @@ -222,7 +222,8 @@ The individual style names on the :doc:`Commands compute ` doc * :doc:`group/group ` - energy/force between two groups of atoms * :doc:`gyration ` - radius of gyration of group of atoms * :doc:`gyration/chunk ` - radius of gyration for each chunk -* :doc:`gyration/shape ` - compute shape parameters from radius of gyration tensor +* :doc:`gyration/shape ` - shape parameters from gyration tensor +* :doc:`gyration/shape/chunk ` - shape parameters from gyration tensor for each chunk * :doc:`heat/flux ` - heat flux through a group of atoms * :doc:`heat/flux/tally ` - * :doc:`hexorder/atom ` - bond orientational order parameter q6 diff --git a/doc/src/compute_gyration_shape.rst b/doc/src/compute_gyration_shape.rst index 68c16f2511..5461825923 100644 --- a/doc/src/compute_gyration_shape.rst +++ b/doc/src/compute_gyration_shape.rst @@ -9,7 +9,7 @@ Syntax .. parsed-literal:: - compute ID group-ID gyration compute-ID + compute ID group-ID gyration/shape compute-ID * ID, group-ID are documented in :doc:`compute ` command * gyration/shape = style name of this compute command @@ -36,7 +36,9 @@ and the relative shape anisotropy, k: .. image:: Eqs/compute_shape_parameters.jpg :align: center -where lx <= ly <= lz are the three eigenvalues of the gyration tensor. +where lx <= ly <= lz are the three eigenvalues of the gyration tensor. A general description +of these parameters is provided in :ref:`(Mattice) ` while an application to polymer systems +can be found in :ref:`(Theodorou) `. 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 @@ -91,18 +93,18 @@ Related commands ---------- -.. _Theodorou: - - - -**(Theodorou)** Theodorou, Suter, Macromolecules, 18, 1206 (1985). - -.. _Mattice: +.. _Mattice1: **(Mattice)** Mattice, Suter, Conformational Theory of Large Molecules, Wiley, New York, 1994. +.. _Theodorou1: + + + +**(Theodorou)** Theodorou, Suter, Macromolecules, 18, 1206 (1985). + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html From 29b2dc7043d3f23bd9d84b30cd6e3142206f89be Mon Sep 17 00:00:00 2001 From: lucienPan Date: Fri, 8 Nov 2019 16:11:34 -0500 Subject: [PATCH 363/557] Patch of class2 dihedral Fix the nan problem when any two bonds are nearly parallel --- src/CLASS2/dihedral_class2.cpp | 70 ++++++++++++++++++---------------- 1 file changed, 37 insertions(+), 33 deletions(-) diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index 11faefee8f..0854c007a0 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -27,7 +27,6 @@ #include "math_const.h" #include "memory.h" #include "error.h" -#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -182,6 +181,11 @@ void DihedralClass2::compute(int eflag, int vflag) costh13 = c0; costh23 = (vb2xm*vb3x + vb2ym*vb3y + vb2zm*vb3z) * r12c2; + costh12 = MAX(MIN(costh12, 1.0), -1.0); + costh13 = MAX(MIN(costh12, 1.0), -1.0); + costh23 = MAX(MIN(costh12, 1.0), -1.0); + c0 = costh13; + // cos and sin of 2 angles and final c sin2 = MAX(1.0 - costh12*costh12,0.0); @@ -836,45 +840,45 @@ void DihedralClass2::read_restart(FILE *fp) allocate(); if (comm->me == 0) { - utils::sfread(FLERR,&k1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&k2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&k3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&k1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&k2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&k3[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi3[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&aat_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&aat_k[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp); } MPI_Bcast(&k1[1],atom->ndihedraltypes,MPI_DOUBLE,0,world); From e5933ecc4abf20fe36d644775135aaaa52e4d48e Mon Sep 17 00:00:00 2001 From: lucienPan Date: Fri, 8 Nov 2019 16:22:57 -0500 Subject: [PATCH 364/557] Fix previous submission of nan problem --- src/CLASS2/dihedral_class2.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index 0854c007a0..7204e58e7a 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -182,8 +182,8 @@ void DihedralClass2::compute(int eflag, int vflag) costh23 = (vb2xm*vb3x + vb2ym*vb3y + vb2zm*vb3z) * r12c2; costh12 = MAX(MIN(costh12, 1.0), -1.0); - costh13 = MAX(MIN(costh12, 1.0), -1.0); - costh23 = MAX(MIN(costh12, 1.0), -1.0); + costh13 = MAX(MIN(costh13, 1.0), -1.0); + costh23 = MAX(MIN(costh23, 1.0), -1.0); c0 = costh13; // cos and sin of 2 angles and final c From 4baa665a80a7e96d5ad409f897d8e7f05fadd963 Mon Sep 17 00:00:00 2001 From: lucienPan Date: Fri, 8 Nov 2019 16:11:34 -0500 Subject: [PATCH 365/557] Patch of class2 dihedral Fix the NAN problem when any two bonds are nearly parallel --- src/CLASS2/dihedral_class2.cpp | 70 ++++++++++++++++++---------------- 1 file changed, 37 insertions(+), 33 deletions(-) diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index 11faefee8f..7204e58e7a 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -27,7 +27,6 @@ #include "math_const.h" #include "memory.h" #include "error.h" -#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -182,6 +181,11 @@ void DihedralClass2::compute(int eflag, int vflag) costh13 = c0; costh23 = (vb2xm*vb3x + vb2ym*vb3y + vb2zm*vb3z) * r12c2; + costh12 = MAX(MIN(costh12, 1.0), -1.0); + costh13 = MAX(MIN(costh13, 1.0), -1.0); + costh23 = MAX(MIN(costh23, 1.0), -1.0); + c0 = costh13; + // cos and sin of 2 angles and final c sin2 = MAX(1.0 - costh12*costh12,0.0); @@ -836,45 +840,45 @@ void DihedralClass2::read_restart(FILE *fp) allocate(); if (comm->me == 0) { - utils::sfread(FLERR,&k1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&k2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&k3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&phi3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&k1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&k2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&k3[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&phi3[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&aat_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&aat_k[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); - utils::sfread(FLERR,&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - utils::sfread(FLERR,&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + fread(&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp); + fread(&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp); } MPI_Bcast(&k1[1],atom->ndihedraltypes,MPI_DOUBLE,0,world); From 59b5ef8fb0f762db5b3933fa3401a36021e0321c Mon Sep 17 00:00:00 2001 From: lucienPan Date: Fri, 8 Nov 2019 17:17:01 -0500 Subject: [PATCH 366/557] Patch of Dihedral class2 --- src/CLASS2/dihedral_class2.cpp | 70 +++++++++++++++++----------------- 1 file changed, 34 insertions(+), 36 deletions(-) diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index 7204e58e7a..a164edcb6d 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -2,12 +2,10 @@ 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. ------------------------------------------------------------------------- */ @@ -27,6 +25,7 @@ #include "math_const.h" #include "memory.h" #include "error.h" +#include "utils.h" using namespace LAMMPS_NS; using namespace MathConst; @@ -840,45 +839,45 @@ void DihedralClass2::read_restart(FILE *fp) allocate(); if (comm->me == 0) { - fread(&k1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&k2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&k3[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&phi1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&phi2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&phi3[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&k1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&k2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&k3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&phi1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&phi2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&phi3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&mbt_f1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&mbt_f2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&mbt_f3[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&mbt_r0[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&ebt_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_r0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&ebt_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&ebt_r0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&at_f1_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_f2_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_f3_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&at_f1_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_f2_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_f3_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&at_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&aat_k[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&aat_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&aat_theta0_1[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&aat_theta0_2[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); - fread(&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp); - fread(&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp); + utils::sfread(FLERR,&bb13t_k[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&bb13t_r10[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); + utils::sfread(FLERR,&bb13t_r30[1],sizeof(double),atom->ndihedraltypes,fp,NULL,error); } MPI_Bcast(&k1[1],atom->ndihedraltypes,MPI_DOUBLE,0,world); @@ -962,5 +961,4 @@ void DihedralClass2::write_data(FILE *fp) at_f1_1[i],at_f2_1[i],at_f3_1[i], at_f1_2[i],at_f2_2[i],at_f3_2[i], at_theta0_1[i]*180.0/MY_PI,at_theta0_2[i]*180.0/MY_PI); -} - +} \ No newline at end of file From 599a189545b184c5d159bdde29ecc380b7eff6e7 Mon Sep 17 00:00:00 2001 From: lucienPan Date: Fri, 8 Nov 2019 17:28:49 -0500 Subject: [PATCH 367/557] Patch of class2 dihedral --- src/CLASS2/dihedral_class2.cpp | 5 ++++- 1 file changed, 4 insertions(+), 1 deletion(-) diff --git a/src/CLASS2/dihedral_class2.cpp b/src/CLASS2/dihedral_class2.cpp index a164edcb6d..6b43257908 100644 --- a/src/CLASS2/dihedral_class2.cpp +++ b/src/CLASS2/dihedral_class2.cpp @@ -2,10 +2,12 @@ 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. ------------------------------------------------------------------------- */ @@ -961,4 +963,5 @@ void DihedralClass2::write_data(FILE *fp) at_f1_1[i],at_f2_1[i],at_f3_1[i], at_f1_2[i],at_f2_2[i],at_f3_2[i], at_theta0_1[i]*180.0/MY_PI,at_theta0_2[i]*180.0/MY_PI); -} \ No newline at end of file +} + From 02791e0b4d180d9aa1821e7360b603d6bf0941f1 Mon Sep 17 00:00:00 2001 From: "Ryan S. Elliott" Date: Sun, 10 Nov 2019 17:49:15 -0600 Subject: [PATCH 368/557] Add Install_conda doc --- doc/src/Install.rst | 1 + doc/src/Install_conda.rst | 53 +++++++++++++++++++++++++++++++ doc/src/Install_mac.rst | 8 ++--- doc/txt/Install.txt | 65 --------------------------------------- doc/txt/Install_mac.txt | 43 -------------------------- 5 files changed, 58 insertions(+), 112 deletions(-) create mode 100644 doc/src/Install_conda.rst delete mode 100644 doc/txt/Install.txt delete mode 100644 doc/txt/Install_mac.txt diff --git a/doc/src/Install.rst b/doc/src/Install.rst index 52f7a43503..4a403a336d 100644 --- a/doc/src/Install.rst +++ b/doc/src/Install.rst @@ -15,6 +15,7 @@ need the source code. Install_linux Install_mac Install_windows + Install_conda Install_tarball Install_git diff --git a/doc/src/Install_conda.rst b/doc/src/Install_conda.rst new file mode 100644 index 0000000000..04b8054353 --- /dev/null +++ b/doc/src/Install_conda.rst @@ -0,0 +1,53 @@ +Download an executable for Linux or Mac via Conda +================================================= + +Binaries are available for macOS or Linux via `Conda `_. + +First, one must setup the Conda package manager on your system. Follow the +instructions to install `Miniconda `_, then create a conda +environment (named `my-lammps-env` or whatever you prefer) for your lammps +install: + +.. parsed-literal:: + + % conda config --add channels conda-forge + % conda create -n my-lammps-env + +Then, you can install lammps on your system with the following command: + +.. parsed-literal:: + + % conda activate my-lammps-env + % conda install lammps + +The LAMMPS binary is built with the :ref:`KIM package ` which +results in Conda also installing the `kim-api` binaries when LAMMPS is +installed. In order to use potentials from `openkim.org `_, you can +install the `openkim-models` package + + +.. parsed-literal:: + + % conda install openkim-models + +If you have problems with the installation you can post issues to +`this link `_. + +.. _conda_forge_lammps: https://github.com/conda-forge/lammps-feedstock/issues + +Thanks to Jan Janssen (Max-Planck-Institut für Eisenforschung) for setting +up the Conda capability. + + +.. _openkim: https://openkim.org + +.. _conda: https://docs.conda.io/en/latest/index.html + +.. _mini_conda_install: https://docs.conda.io/en/latest/miniconda.html + + + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/src/Install_mac.rst b/doc/src/Install_mac.rst index 52e059b6b9..cc8bbc9a92 100644 --- a/doc/src/Install_mac.rst +++ b/doc/src/Install_mac.rst @@ -2,9 +2,10 @@ Download an executable for Mac ============================== LAMMPS can be downloaded, built, and configured for OS X on a Mac with -`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. +`Homebrew `_. (Alternatively, see the install instructions for +:doc:`Download an executable via Conda `.) 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: @@ -48,7 +49,6 @@ up the Homebrew capability. - .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Commands_all.html diff --git a/doc/txt/Install.txt b/doc/txt/Install.txt deleted file mode 100644 index 0a2e870a5d..0000000000 --- a/doc/txt/Install.txt +++ /dev/null @@ -1,65 +0,0 @@ -"Previous Section"_Intro.html - "LAMMPS WWW Site"_lws - "LAMMPS -Documentation"_ld - "LAMMPS Commands"_lc - "Next Section"_Build.html -:c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html) - -:line - -Install LAMMPS :h2 - -You can download LAMMPS as an executable or as source code. - -With source code, you also have to "build LAMMPS"_Build.html. But you -have more flexibility as to what features to include or exclude in the -build. If you plan to "modify or extend LAMMPS"_Modify.html, then you -need the source code. - - - - - -"Download an executable for Linux"_Install_linux.html -"Download an executable for Mac"_Install_mac.html -"Download an executable for Windows"_Install_windows.html :all(b) - -"Download source as a tarball"_Install_tarball.html -"Donwload source via Git"_Install_git.html -"Donwload source via SVN"_Install_svn.html -"Install patch files"_Install_patch.html :all(b) - - - -These are the files and sub-directories in the LAMMPS distribution: - -README: text file -LICENSE: GNU General Public License (GPL) -bench: benchmark problems -cmake: CMake build files -doc: documentation -examples: simple test problems -lib: additional provided or external libraries -potentials: interatomic potential files -python: Python wrapper on LAMMPS -src: source files -tools: pre- and post-processing tools :tb(s=:,a=l) - -You will have all of these if you download source. You will only have -some of them if you download executables, as explained on the pages -listed above. diff --git a/doc/txt/Install_mac.txt b/doc/txt/Install_mac.txt deleted file mode 100644 index 773c9ec93a..0000000000 --- a/doc/txt/Install_mac.txt +++ /dev/null @@ -1,43 +0,0 @@ -"Higher level section"_Install.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 - -Download an executable for Mac :h3 - -LAMMPS can be downloaded, built, and configured for OS X on a Mac with -"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 install lammps :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-core/issues) -:link(openkim,https://openkim.org) From 3258a149237ec71dafd2d12e8aeafd3a759bd6d9 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Mon, 11 Nov 2019 18:46:59 +0900 Subject: [PATCH 369/557] initial support for par-atom centroid virial in pair styles --- src/pair.cpp | 47 +++++++++++++++++++++++++++++++++++++++++++---- src/pair.h | 10 ++++++++-- 2 files changed, 51 insertions(+), 6 deletions(-) diff --git a/src/pair.cpp b/src/pair.cpp index 7c8424ce18..d3f67019df 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -72,6 +72,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) ewaldflag = pppmflag = msmflag = dispersionflag = tip4pflag = dipoleflag = spinflag = 0; reinitflag = 1; + cntratmstressflag = 4; // pair_modify settings @@ -91,9 +92,10 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) allocated = 0; suffix_flag = Suffix::NONE; - maxeatom = maxvatom = 0; + maxeatom = maxvatom = maxcvatom = 0; eatom = NULL; vatom = NULL; + cvatom = NULL; num_tally_compute = 0; list_tally_compute = NULL; @@ -122,6 +124,7 @@ Pair::~Pair() memory->destroy(eatom); memory->destroy(vatom); + memory->destroy(cvatom); } /* ---------------------------------------------------------------------- @@ -779,9 +782,20 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) eflag_global = eflag % 2; eflag_atom = eflag / 2; - vflag_either = vflag; vflag_global = vflag % 4; - vflag_atom = vflag / 4; + vflag_atom = vflag & 4; + + if (vflag & 8) { + if (cntratmstressflag & 2) { + cvflag_atom = 1; + } else { + vflag_atom = 1; + } + // extra check, because both bits might be set + if (cntratmstressflag & 1) vflag_atom = 1; + } + + vflag_either = vflag_global || vflag_atom; // reallocate per-atom arrays if necessary @@ -799,6 +813,13 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) memory->create(vatom,comm->nthreads*maxvatom,6,"pair:vatom"); } } + if (cvflag_atom && atom->nmax > maxcvatom) { + maxcvatom = atom->nmax; + if (alloc) { + memory->destroy(cvatom); + memory->create(cvatom,comm->nthreads*maxcvatom,9,"pair:cvatom"); + } + } // zero accumulators // use force->newton instead of newton_pair @@ -823,6 +844,22 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) vatom[i][5] = 0.0; } } + if (cvflag_atom && alloc) { + n = atom->nlocal; + if (force->newton) n += atom->nghost; + for (i = 0; i < n; i++) { + cvatom[i][0] = 0.0; + cvatom[i][1] = 0.0; + cvatom[i][2] = 0.0; + cvatom[i][3] = 0.0; + cvatom[i][4] = 0.0; + cvatom[i][5] = 0.0; + cvatom[i][6] = 0.0; + cvatom[i][7] = 0.0; + cvatom[i][8] = 0.0; + cvatom[i][9] = 0.0; + } + } // if vflag_global = 2 and pair::compute() calls virial_fdotr_compute() // compute global virial via (F dot r) instead of via pairwise summation @@ -831,7 +868,7 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) if (vflag_global == 2 && no_virial_fdotr_compute == 0) { vflag_fdotr = 1; vflag_global = 0; - if (vflag_atom == 0) vflag_either = 0; + if (vflag_atom == 0 && cvflag_atom == 0) vflag_either = 0; if (vflag_either == 0 && eflag_either == 0) evflag = 0; } else vflag_fdotr = 0; @@ -863,6 +900,7 @@ void Pair::ev_unset() vflag_either = 0; vflag_global = 0; vflag_atom = 0; + cvflag_atom = 0; vflag_fdotr = 0; } @@ -1760,6 +1798,7 @@ double Pair::memory_usage() { double bytes = comm->nthreads*maxeatom * sizeof(double); bytes += comm->nthreads*maxvatom*6 * sizeof(double); + bytes += comm->nthreads*maxcvatom*9 * sizeof(double); return bytes; } diff --git a/src/pair.h b/src/pair.h index a0269bd5b2..d28ed60827 100644 --- a/src/pair.h +++ b/src/pair.h @@ -36,6 +36,7 @@ class Pair : protected Pointers { double eng_vdwl,eng_coul; // accumulated energies double virial[6]; // accumulated virial double *eatom,**vatom; // accumulated per-atom energy/virial + double **cvatom; // accumulated per-atom centroid virial double cutforce; // max cutoff for all atom pairs double **cutsq; // cutoff sq for each atom pair @@ -65,13 +66,18 @@ class Pair : protected Pointers { int spinflag; // 1 if compatible with spin solver int reinitflag; // 1 if compatible with fix adapt and alike + int cntratmstressflag; // compatibility with centroid atomic stress + // 1 if same as pairwise atomic stress + // 2 if implemented and different from pairwise + // 4 if not compatible/implemented + int tail_flag; // pair_modify flag for LJ tail correction double etail,ptail; // energy/pressure tail corrections double etail_ij,ptail_ij; int evflag; // energy,virial settings int eflag_either,eflag_global,eflag_atom; - int vflag_either,vflag_global,vflag_atom; + int vflag_either,vflag_global,vflag_atom,cvflag_atom; int ncoultablebits; // size of Coulomb table, accessed by KSpace int ndisptablebits; // size of dispersion table @@ -229,7 +235,7 @@ class Pair : protected Pointers { protected: int vflag_fdotr; - int maxeatom,maxvatom; + int maxeatom,maxvatom,maxcvatom; int copymode; // if set, do not deallocate during destruction // required when classes are used as functors by Kokkos From 61a286a0da789bbe08338e12576450357fb150df Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Mon, 11 Nov 2019 19:16:21 +0900 Subject: [PATCH 370/557] compute centroid/atom/stress will use cvatom from pair styles when available --- src/compute_centroid_stress_atom.cpp | 19 +++++++++++++------ 1 file changed, 13 insertions(+), 6 deletions(-) diff --git a/src/compute_centroid_stress_atom.cpp b/src/compute_centroid_stress_atom.cpp index 86ea4b45af..a78c2ee421 100644 --- a/src/compute_centroid_stress_atom.cpp +++ b/src/compute_centroid_stress_atom.cpp @@ -173,12 +173,19 @@ void ComputeCentroidStressAtom::compute_peratom() // per-atom virial and per-atom centroid virial are the same for pairwise // many-body pair styles not yet implemented if (pairflag && force->pair) { - double **vatom = force->pair->vatom; - for (i = 0; i < npair; i++) { - for (j = 0; j < 6; j++) - stress[i][j] += vatom[i][j]; - for (j = 6; j < 9; j++) - stress[i][j] += vatom[i][j-3]; + if (force->pair->cntratmstressflag & 2) { + double **cvatom = force->pair->cvatom; + for (i = 0; i < npair; i++) + for (j = 0; j < 9; j++) + stress[i][j] += cvatom[i][j]; + } else { + double **vatom = force->pair->vatom; + for (i = 0; i < npair; i++) { + for (j = 0; j < 6; j++) + stress[i][j] += vatom[i][j]; + for (j = 6; j < 9; j++) + stress[i][j] += vatom[i][j-3]; + } } } From a782245179b192d465ec92fe20b8642130c1eaae Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Mon, 11 Nov 2019 19:39:01 +0900 Subject: [PATCH 371/557] support for par-atom centroid virial in pair hybrid --- src/pair_hybrid.cpp | 24 ++++++++++++++++++++++++ 1 file changed, 24 insertions(+) diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index b853ef1db1..0fdca8e416 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -40,6 +40,10 @@ PairHybrid::PairHybrid(LAMMPS *lmp) : Pair(lmp), outerflag = 0; respaflag = 0; + + // assume pair hybrid always supports centroid atomic stress, + // so that cflag_atom gets set when needed + cntratmstressflag = 2; } /* ---------------------------------------------------------------------- */ @@ -159,6 +163,24 @@ void PairHybrid::compute(int eflag, int vflag) for (j = 0; j < 6; j++) vatom[i][j] += vatom_substyle[i][j]; } + if (cvflag_atom) { + n = atom->nlocal; + if (force->newton_pair) n += atom->nghost; + if (styles[m]->cntratmstressflag & 2) { + double **cvatom_substyle = styles[m]->cvatom; + for (i = 0; i < n; i++) + for (j = 0; j < 9; j++) + cvatom[i][j] += cvatom_substyle[i][j]; + } else { + double **vatom_substyle = styles[m]->vatom; + for (i = 0; i < n; i++) + for (j = 0; j < 6; j++) + cvatom[i][j] += vatom_substyle[i][j]; + for (j = 6; j < 9; j++) + cvatom[i][j] += vatom_substyle[i][j-3]; + } + } + } delete [] saved_special; @@ -362,6 +384,7 @@ void PairHybrid::flags() if (styles[m]->dispersionflag) dispersionflag = 1; if (styles[m]->tip4pflag) tip4pflag = 1; if (styles[m]->compute_flag) compute_flag = 1; + cntratmstressflag |= styles[m]->cntratmstressflag; } init_svector(); } @@ -1015,6 +1038,7 @@ double PairHybrid::memory_usage() { double bytes = maxeatom * sizeof(double); bytes += maxvatom*6 * sizeof(double); + bytes += maxcvatom*9 * sizeof(double); for (int m = 0; m < nstyles; m++) bytes += styles[m]->memory_usage(); return bytes; } From 7937bec396d478ef52955dd1a8abd800c8422aba Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Mon, 11 Nov 2019 22:45:59 +0900 Subject: [PATCH 372/557] add pair style compatibility check to compute centroid/stress/atom --- src/compute_centroid_stress_atom.cpp | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/src/compute_centroid_stress_atom.cpp b/src/compute_centroid_stress_atom.cpp index a78c2ee421..dfab2b878a 100644 --- a/src/compute_centroid_stress_atom.cpp +++ b/src/compute_centroid_stress_atom.cpp @@ -123,6 +123,11 @@ void ComputeCentroidStressAtom::init() if (temperature->tempbias) biasflag = BIAS; else biasflag = NOBIAS; } else biasflag = NOBIAS; + + // check if pair styles support centroid atom stress + if (pairflag && force->pair) + if (force->pair->cntratmstressflag & 4) + error->all(FLERR, "Pair style does not support compute centroid/stress/atom"); } /* ---------------------------------------------------------------------- */ From 0a64dff132fa173f085d4498c6cdbae6c7d5a947 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Mon, 11 Nov 2019 23:27:10 +0900 Subject: [PATCH 373/557] add initial support to centroid virial in USER-OMP pair styles --- src/USER-OMP/thr_data.h | 1 + src/USER-OMP/thr_omp.cpp | 17 +++++++++++++++++ 2 files changed, 18 insertions(+) diff --git a/src/USER-OMP/thr_data.h b/src/USER-OMP/thr_data.h index 028d9dd938..2c1e42a3a3 100644 --- a/src/USER-OMP/thr_data.h +++ b/src/USER-OMP/thr_data.h @@ -97,6 +97,7 @@ class ThrData { double **vatom_dihed; double **vatom_imprp; double **vatom_kspce; + double **cvatom_pair; double **cvatom_angle; double **cvatom_dihed; double **cvatom_imprp; diff --git a/src/USER-OMP/thr_omp.cpp b/src/USER-OMP/thr_omp.cpp index 172d5e816a..ca754b9732 100644 --- a/src/USER-OMP/thr_omp.cpp +++ b/src/USER-OMP/thr_omp.cpp @@ -82,6 +82,15 @@ void ThrOMP::ev_setup_thr(int eflag, int vflag, int nall, double *eatom, if (nall > 0) memset(&(thr->vatom_pair[0][0]),0,nall*6*sizeof(double)); } + // check cvatom_pair, because can't access cntratmstressflag + if ((vflag & 8) && cvatom) { + thr->cvatom_pair = cvatom + tid*nall; + if (nall > 0) + memset(&(thr->cvatom_pair[0][0]),0,nall*9*sizeof(double)); + } else { + thr->cvatom_pair = NULL; + } + } if (thr_style & THR_BOND) { @@ -234,6 +243,10 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); } + // check cvatom_pair, because can't access cntratmstressflag + if ((vflag & 8) && thr->cvatom_pair) { + data_reduce_thr(&(pair->cvatom[0][0]), nall, nthreads, 9, tid); + } } } break; @@ -381,6 +394,10 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); } + // check cvatom_pair, because can't access cntratmstressflag + if ((vflag & 8) && thr->cvatom_pair) { + data_reduce_thr(&(pair->cvatom[0][0]), nall, nthreads, 9, tid); + } } break; From 7db3d7b5c07a984cbc038c643710ed10ef32ad6b Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Tue, 12 Nov 2019 00:02:50 +0900 Subject: [PATCH 374/557] setting cntatmstressflag = 1 for true pariwise styles --- src/CLASS2/pair_lj_class2.cpp | 1 + src/CLASS2/pair_lj_class2_coul_cut.cpp | 1 + src/PYTHON/pair_python.cpp | 1 + src/USER-FEP/pair_coul_cut_soft.cpp | 4 +++- src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp | 1 + src/USER-FEP/pair_lj_class2_soft.cpp | 1 + src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp | 1 + src/USER-FEP/pair_lj_cut_soft.cpp | 1 + src/pair_beck.cpp | 4 +++- src/pair_buck.cpp | 1 + src/pair_buck_coul_cut.cpp | 1 + src/pair_coul_cut.cpp | 4 +++- src/pair_coul_dsf.cpp | 4 +++- src/pair_coul_wolf.cpp | 1 + src/pair_lj_cubic.cpp | 4 +++- src/pair_lj_cut.cpp | 1 + src/pair_lj_cut_coul_cut.cpp | 1 + src/pair_lj_cut_coul_dsf.cpp | 1 + src/pair_lj_cut_coul_wolf.cpp | 1 + src/pair_lj_expand.cpp | 1 + src/pair_lj_gromacs_coul_gromacs.cpp | 1 + src/pair_lj_smooth.cpp | 1 + src/pair_lj_smooth_linear.cpp | 1 + src/pair_morse.cpp | 1 + src/pair_ufm.cpp | 1 + 25 files changed, 35 insertions(+), 5 deletions(-) diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp index c930173864..a304390b5d 100644 --- a/src/CLASS2/pair_lj_class2.cpp +++ b/src/CLASS2/pair_lj_class2.cpp @@ -35,6 +35,7 @@ PairLJClass2::PairLJClass2(LAMMPS *lmp) : Pair(lmp) { respa_enable = 1; writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/CLASS2/pair_lj_class2_coul_cut.cpp b/src/CLASS2/pair_lj_class2_coul_cut.cpp index 89a0d74b5a..c1d5253d9a 100644 --- a/src/CLASS2/pair_lj_class2_coul_cut.cpp +++ b/src/CLASS2/pair_lj_class2_coul_cut.cpp @@ -33,6 +33,7 @@ using namespace MathConst; PairLJClass2CoulCut::PairLJClass2CoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/PYTHON/pair_python.cpp b/src/PYTHON/pair_python.cpp index 0d79a31946..819f125496 100644 --- a/src/PYTHON/pair_python.cpp +++ b/src/PYTHON/pair_python.cpp @@ -40,6 +40,7 @@ PairPython::PairPython(LAMMPS *lmp) : Pair(lmp) { one_coeff = 1; reinitflag = 0; cut_global = 0.0; + cntratmstressflag = 1; py_potential = NULL; skip_types = NULL; diff --git a/src/USER-FEP/pair_coul_cut_soft.cpp b/src/USER-FEP/pair_coul_cut_soft.cpp index 5a87a2f740..bed357d663 100644 --- a/src/USER-FEP/pair_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_coul_cut_soft.cpp @@ -32,7 +32,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -PairCoulCutSoft::PairCoulCutSoft(LAMMPS *lmp) : Pair(lmp) {} +PairCoulCutSoft::PairCoulCutSoft(LAMMPS *lmp) : Pair(lmp) { + cntratmstressflag = 1; +} /* ---------------------------------------------------------------------- */ 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 4913cf1271..c7319d574c 100644 --- a/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp @@ -33,6 +33,7 @@ using namespace MathConst; PairLJClass2CoulCutSoft::PairLJClass2CoulCutSoft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-FEP/pair_lj_class2_soft.cpp b/src/USER-FEP/pair_lj_class2_soft.cpp index eccc07f7c1..7b8cdeb29c 100644 --- a/src/USER-FEP/pair_lj_class2_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_soft.cpp @@ -32,6 +32,7 @@ using namespace MathConst; PairLJClass2Soft::PairLJClass2Soft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ 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 6e5e746879..42ce3fe44d 100644 --- a/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp @@ -37,6 +37,7 @@ using namespace MathConst; PairLJCutCoulCutSoft::PairLJCutCoulCutSoft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-FEP/pair_lj_cut_soft.cpp b/src/USER-FEP/pair_lj_cut_soft.cpp index 62b7e76977..bcbf2770ad 100644 --- a/src/USER-FEP/pair_lj_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_soft.cpp @@ -43,6 +43,7 @@ PairLJCutSoft::PairLJCutSoft(LAMMPS *lmp) : Pair(lmp) respa_enable = 1; writedata = 1; allocated = 0; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_beck.cpp b/src/pair_beck.cpp index 1f058b9bd5..981dd5026d 100644 --- a/src/pair_beck.cpp +++ b/src/pair_beck.cpp @@ -32,7 +32,9 @@ using namespace MathSpecial; /* ---------------------------------------------------------------------- */ -PairBeck::PairBeck(LAMMPS *lmp) : Pair(lmp) {} +PairBeck::PairBeck(LAMMPS *lmp) : Pair(lmp) { + cntratmstressflag = 1; +} /* ---------------------------------------------------------------------- */ diff --git a/src/pair_buck.cpp b/src/pair_buck.cpp index 4a7740e034..9e8c1fac59 100644 --- a/src/pair_buck.cpp +++ b/src/pair_buck.cpp @@ -32,6 +32,7 @@ using namespace MathConst; PairBuck::PairBuck(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_buck_coul_cut.cpp b/src/pair_buck_coul_cut.cpp index d74945aa57..022959eacb 100644 --- a/src/pair_buck_coul_cut.cpp +++ b/src/pair_buck_coul_cut.cpp @@ -36,6 +36,7 @@ using namespace MathConst; PairBuckCoulCut::PairBuckCoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_cut.cpp b/src/pair_coul_cut.cpp index ebb3d8ca0d..edefd014ab 100644 --- a/src/pair_coul_cut.cpp +++ b/src/pair_coul_cut.cpp @@ -28,7 +28,9 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ -PairCoulCut::PairCoulCut(LAMMPS *lmp) : Pair(lmp) {} +PairCoulCut::PairCoulCut(LAMMPS *lmp) : Pair(lmp) { + cntratmstressflag = 1; +} /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_dsf.cpp b/src/pair_coul_dsf.cpp index 0a248e3084..f43dbb139a 100644 --- a/src/pair_coul_dsf.cpp +++ b/src/pair_coul_dsf.cpp @@ -43,7 +43,9 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ -PairCoulDSF::PairCoulDSF(LAMMPS *lmp) : Pair(lmp) {} +PairCoulDSF::PairCoulDSF(LAMMPS *lmp) : Pair(lmp) { + cntratmstressflag = 1; +} /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_wolf.cpp b/src/pair_coul_wolf.cpp index 9c48137270..e5318f43d5 100644 --- a/src/pair_coul_wolf.cpp +++ b/src/pair_coul_wolf.cpp @@ -36,6 +36,7 @@ using namespace MathConst; PairCoulWolf::PairCoulWolf(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; // NOTE: single() method below is not yet correct + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cubic.cpp b/src/pair_lj_cubic.cpp index 98f221b689..392604c558 100644 --- a/src/pair_lj_cubic.cpp +++ b/src/pair_lj_cubic.cpp @@ -32,7 +32,9 @@ using namespace PairLJCubicConstants; /* ---------------------------------------------------------------------- */ -PairLJCubic::PairLJCubic(LAMMPS *lmp) : Pair(lmp) {} +PairLJCubic::PairLJCubic(LAMMPS *lmp) : Pair(lmp) { + cntratmstressflag = 1; +} /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut.cpp b/src/pair_lj_cut.cpp index 8765ba4313..2e1eba2011 100644 --- a/src/pair_lj_cut.cpp +++ b/src/pair_lj_cut.cpp @@ -41,6 +41,7 @@ PairLJCut::PairLJCut(LAMMPS *lmp) : Pair(lmp) { respa_enable = 1; writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_cut.cpp b/src/pair_lj_cut_coul_cut.cpp index 621148dc9b..1d85fa1745 100644 --- a/src/pair_lj_cut_coul_cut.cpp +++ b/src/pair_lj_cut_coul_cut.cpp @@ -33,6 +33,7 @@ using namespace MathConst; PairLJCutCoulCut::PairLJCutCoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_dsf.cpp b/src/pair_lj_cut_coul_dsf.cpp index 3b78b8ad1d..2b243990a4 100644 --- a/src/pair_lj_cut_coul_dsf.cpp +++ b/src/pair_lj_cut_coul_dsf.cpp @@ -46,6 +46,7 @@ using namespace MathConst; PairLJCutCoulDSF::PairLJCutCoulDSF(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_wolf.cpp b/src/pair_lj_cut_coul_wolf.cpp index b4eaa070a7..0f0a7413fa 100644 --- a/src/pair_lj_cut_coul_wolf.cpp +++ b/src/pair_lj_cut_coul_wolf.cpp @@ -37,6 +37,7 @@ PairLJCutCoulWolf::PairLJCutCoulWolf(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_expand.cpp b/src/pair_lj_expand.cpp index 16c8d586a2..988305d394 100644 --- a/src/pair_lj_expand.cpp +++ b/src/pair_lj_expand.cpp @@ -32,6 +32,7 @@ using namespace MathConst; PairLJExpand::PairLJExpand(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_gromacs_coul_gromacs.cpp b/src/pair_lj_gromacs_coul_gromacs.cpp index 53b62bfdbd..e378b333e5 100644 --- a/src/pair_lj_gromacs_coul_gromacs.cpp +++ b/src/pair_lj_gromacs_coul_gromacs.cpp @@ -34,6 +34,7 @@ using namespace LAMMPS_NS; PairLJGromacsCoulGromacs::PairLJGromacsCoulGromacs(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_smooth.cpp b/src/pair_lj_smooth.cpp index 8c906dee46..e6c39a8f92 100644 --- a/src/pair_lj_smooth.cpp +++ b/src/pair_lj_smooth.cpp @@ -33,6 +33,7 @@ using namespace LAMMPS_NS; PairLJSmooth::PairLJSmooth(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 16d5e96c12..4b3b43fbcb 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -32,6 +32,7 @@ using namespace LAMMPS_NS; PairLJSmoothLinear::PairLJSmoothLinear(LAMMPS *lmp) : Pair(lmp) { single_hessian_enable = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_morse.cpp b/src/pair_morse.cpp index 86f0e34bf8..9722780922 100644 --- a/src/pair_morse.cpp +++ b/src/pair_morse.cpp @@ -30,6 +30,7 @@ using namespace LAMMPS_NS; PairMorse::PairMorse(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_ufm.cpp b/src/pair_ufm.cpp index ba3ad9ee50..9fd2ebe880 100644 --- a/src/pair_ufm.cpp +++ b/src/pair_ufm.cpp @@ -36,6 +36,7 @@ using namespace LAMMPS_NS; PairUFM::PairUFM(LAMMPS *lmp) : Pair(lmp) { writedata = 1; + cntratmstressflag = 1; } /* ---------------------------------------------------------------------- */ From 5ba7686939064aa32f24f0f42757a124a16e95b3 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Tue, 12 Nov 2019 01:40:59 +0900 Subject: [PATCH 375/557] add documentation about centroid/stress/atom compute --- doc/src/compute_stress_atom.rst | 147 ++++++++++++++++++++++++-------- 1 file changed, 111 insertions(+), 36 deletions(-) diff --git a/doc/src/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst index 07d3526041..5ea34f68f6 100644 --- a/doc/src/compute_stress_atom.rst +++ b/doc/src/compute_stress_atom.rst @@ -2,6 +2,8 @@ compute stress/atom command =========================== +compute centroid/stress/atom command +==================================== Syntax """""" @@ -9,10 +11,10 @@ Syntax .. parsed-literal:: - compute ID group-ID stress/atom temp-ID keyword ... + compute ID group-ID style temp-ID keyword ... * ID, group-ID are documented in :doc:`compute ` command -* stress/atom = style name of this compute command +* style = *stress/atom* or *centroid/stress/atom* * 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* @@ -26,38 +28,62 @@ Examples compute 1 mobile stress/atom NULL compute 1 mobile stress/atom myRamp compute 1 all stress/atom NULL pair bond + compute 1 all centroid/stress/atom NULL bond dihedral improper Description """"""""""" -Define a computation that computes the symmetric per-atom stress -tensor for each atom in a group. The tensor for each atom has 6 +Define a computation that computes per-atom stress +tensor for each atom in a group. In case of compute *stress/atom*, +the tensor for each atom is symmetric with 6 components and is stored as a 6-element vector in the following order: -xx, yy, zz, xy, xz, yz. See the :doc:`compute pressure ` command if you want the stress tensor +:math:`xx`, :math:`yy`, :math:`zz`, :math:`xy`, :math:`xz`, :math:`yz`. +In case of compute *centroid/stress/atom*, +the tensor for each atom is asymmetric with 9 components +and is stored as a 9-element vector in the following order: +:math:`xx`, :math:`yy`, :math:`zz`, :math:`xy`, :math:`xz`, :math:`yz`, +:math:`yx`, :math:`zx`, :math:`zy`. +See the :doc:`compute pressure ` command if you want the stress tensor (pressure) of the entire system. -The stress tensor for atom *I* is given by the following formula, -where *a* and *b* take on values x,y,z to generate the 6 components of -the symmetric tensor: +The stress tensor for atom :math:`I` is given by the following formula, +where :math:`a` and :math:`b` take on values :math:`x`, :math:`y`, :math:`z` +to generate the components of the tensor: -.. image:: Eqs/stress_tensor.jpg - :align: center +.. math:: -The first term is a kinetic energy contribution for atom *I*\ . See + S_{ab} = - m v_a v_b - W_{ab} + +The first term is a kinetic energy contribution for atom :math:`I`. See details below on how the specified *temp-ID* can affect the velocities -used in this calculation. The second term is a pairwise energy -contribution where *n* loops over the *Np* neighbors of atom *I*\ , *r1* -and *r2* are the positions of the 2 atoms in the pairwise interaction, -and *F1* and *F2* are the forces on the 2 atoms resulting from the -pairwise interaction. The third term is a bond contribution of -similar form for the *Nb* bonds which atom *I* is part of. There are -similar terms for the *Na* angle, *Nd* dihedral, and *Ni* improper -interactions atom *I* is part of. There is also a term for the KSpace -contribution from long-range Coulombic interactions, if defined. -Finally, there is a term for the *Nf* :doc:`fixes ` that apply -internal constraint forces to atom *I*\ . Currently, only the :doc:`fix shake ` and :doc:`fix rigid ` commands -contribute to this term. +used in this calculation. The second term is the virial +contribution due to intra and intermolecular interactions, +where the exact computation details are determined by the compute style. +In case of compute *stress/atom*, the virial contribution is: + +.. math:: + + W_{ab} & = \frac{1}{2} \sum_{n = 1}^{N_p} (r_{1_a} F_{1_b} + r_{2_a} F_{2_b}) + \frac{1}{2} \sum_{n = 1}^{N_b} (r_{1_a} F_{1_b} + r_{2_a} F_{2_b}) \\ + & + \frac{1}{3} \sum_{n = 1}^{N_a} (r_{1_a} F_{1_b} + r_{2_a} F_{2_b} + r_{3_a} F_{3_b}) + \frac{1}{4} \sum_{n = 1}^{N_d} (r_{1_a} F_{1_b} + r_{2_a} F_{2_b} + r_{3_a} F_{3_b} + r_{4_a} F_{4_b}) \\ + & + \frac{1}{4} \sum_{n = 1}^{N_i} (r_{1_a} F_{1_b} + r_{2_a} F_{2_b} + r_{3_a} F_{3_b} + r_{4_a} F_{4_b}) + {\rm Kspace}(r_{i_a},F_{i_b}) + \sum_{n = 1}^{N_f} r_{i_a} F_{i_b} + +The first term is a pairwise energy +contribution where :math:`n` loops over the :math:`N_p` +neighbors of atom :math:`I`, :math:`\mathbf{r}_1` and :math:`\mathbf{r}_2` +are the positions of the 2 atoms in the pairwise interaction, +and :math:`\mathbf{F}_1` and :math:`\mathbf{F}_2` are the forces +on the 2 atoms resulting from the pairwise interaction. +The second term is a bond contribution of +similar form for the :math:`N_b` bonds which atom :math:`I` is part of. +There are similar terms for the :math:`N_a` angle, :math:`N_d` dihedral, +and :math:`N_i` improper interactions atom :math:`I` is part of. +There is also a term for the KSpace +contribution from long-range Coulombic interactions, if defined. +Finally, there is a term for the :math:`N_f` :doc:`fixes ` that apply +internal constraint forces to atom :math:`I`. Currently, only the +:doc:`fix shake ` and :doc:`fix rigid ` commands +contribute to this term. As the coefficients in the formula imply, a virial contribution produced by a small set of atoms (e.g. 4 atoms in a dihedral or 3 atoms in a Tersoff 3-body interaction) is assigned in equal portions @@ -66,7 +92,32 @@ the 4 atoms, or 1/3 of the fix virial due to SHAKE constraints applied to atoms in a water molecule via the :doc:`fix shake ` command. -If no extra keywords are listed, all of the terms in this formula are +In case of compute *centroid/stress/atom*, the virial contribution is: + +.. math:: + + W_{ab} & = \sum_{n = 1}^{N_p} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_b} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_a} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_d} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_i} r_{I0_a} F_{I_b} \\ + & + {\rm Kspace}(r_{i_a},F_{i_b}) + \sum_{n = 1}^{N_f} r_{i_a} F_{i_b} + +As with compute *stress/atom*, the first, second, third, forth and fifth terms +are pairwise, bond, angle, dihedral and improper contributions, +but instead of assigning the virial contribution equally to each atom, +only the force :math:`\mathbf{F}_I` acting on atom :math:`I` +due to the interaction and the relative +position :math:`\mathbf{r}_{I0}` of the atom :math:`I` to the geometric center +of the interacting atoms, i.e. centroid, is used. +As the geometric center is different +for each interaction, the :math:`\mathbf{r}_{I0}` also differs. +The sixth and seventh terms, Kspace and :doc:`fix ` contribution +respectively, are computed identical to compute *stress/atom*. +Although the total system virial is the same as compute *stress/atom*, +compute *centroid/stress/atom* is know to result in more consistent +heat flux values for three and larger many-body interactions +such as angles, dihedrals and impropers, +when computed via :doc:`compute heat/flux `. + +If no extra keywords are listed, the kinetic contribution +all of the virial contribution terms are included in the per-atom stress tensor. If any extra keywords are listed, only those terms are summed to compute the tensor. The *virial* keyword means include all terms except the kinetic energy @@ -75,17 +126,28 @@ listed, only those terms are summed to compute the tensor. The Note that the stress for each atom is due to its interaction with all other atoms in the simulation, not just with other atoms in the group. -Details of how LAMMPS computes the virial for individual atoms for +Details of how compute *stress/atom* obtains the virial for individual atoms for either pairwise or many-body potentials, and including the effects of periodic boundary conditions is discussed in :ref:`(Thompson) `. The basic idea for many-body potentials is to treat each component of the force computation between a small cluster of atoms in the same manner as in the formula above for bond, angle, dihedral, etc -interactions. Namely the quantity R dot F is summed over the atoms in -the interaction, with the R vectors unwrapped by periodic boundaries +interactions. Namely the quantity :math:`\mathbf{r} \cdot \mathbf{F}` +is summed over the atoms in +the interaction, with the :math:`r` vectors unwrapped by periodic boundaries so that the cluster of atoms is close together. The total contribution for the cluster interaction is divided evenly among those -atoms. +atoms. Details of how compute *centroid/stress/atom* obtains +the virial for individual atoms for many-body potentials +is given in :ref:`(Surblys) `, +where the idea is that the virial of the atom :math:`I` +is the result of only the force :math:`\mathbf{F}_I` on the atom due +to the many-body interaction +and its positional vector :math:`\mathbf{r}_{I0}`, +relative to the geometric center of the +interacting atoms. The periodic boundary treatment is identical to +that of compute *stress/atom*, and both of them reduce to identical +expressions for pairwise interactions. The :doc:`dihedral\_style charmm ` style calculates pairwise interactions between 1-4 atoms. The virial contribution of @@ -126,12 +188,13 @@ See the :doc:`compute voronoi/atom ` command for one possible way to estimate a per-atom volume. Thus, if the diagonal components of the per-atom stress tensor are -summed for all atoms in the system and the sum is divided by dV, where -d = dimension and V is the volume of the system, the result should be --P, where P is the total pressure of the system. +summed for all atoms in the system and the sum is divided by :math:`dV`, where +:math:`d` = dimension and :math:`V` is the volume of the system, +the result should be :math:`-P`, where :math:`P` +is the total pressure of the system. These lines in an input script for a 3d system should yield that -result. I.e. the last 2 columns of thermo output will be the same: +result. I.e. the last 2 columns of thermo output will be the same: .. parsed-literal:: @@ -149,9 +212,12 @@ result. I.e. the last 2 columns of thermo output will be the same: **Output info:** -This compute calculates a per-atom array with 6 columns, which can be +This compute *stress/atom* calculates a per-atom array with 6 columns, which can be accessed by indices 1-6 by any command that uses per-atom values from -a compute as input. See the :doc:`Howto output ` doc page +a compute as input. +The compute "centroid/stress/atom* produces a per-atom array with 9 columns, +but otherwise can be used in an identical manner to compute *stress/atom*. +See the :doc:`Howto output ` doc page for an overview of LAMMPS output options. The per-atom array values will be in pressure\*volume @@ -159,7 +225,10 @@ The per-atom array values will be in pressure\*volume Restrictions """""""""""" - none +Pair styles with three and larger many-body interactions, +such as Tersoff do not currently support +compute *centroid/stress/atom* and LAMMPS will generate an error +in such cases. Related commands """""""""""""""" @@ -176,7 +245,7 @@ Related commands -**(Heyes)** Heyes, Phys Rev B 49, 755 (1994), +**(Heyes)** Heyes, Phys Rev B, 49, 755 (1994). .. _Sirk1: @@ -190,6 +259,12 @@ Related commands **(Thompson)** Thompson, Plimpton, Mattson, J Chem Phys, 131, 154107 (2009). +.. _Surblys1: + + + +**(Surblys)** Surblys, Matsubara, Kikugawa, Ohara, Phys Rev E, 99, 051301(R) (2019). + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html From 16f67ee56a863601fdb750a7179c5a5bcaa95218 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Mon, 11 Nov 2019 15:26:48 -0500 Subject: [PATCH 376/557] Add new words to false-positives.txt --- doc/utils/sphinx-config/false_positives.txt | 7 +++++++ 1 file changed, 7 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index c9396984f6..5b3020c7d1 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -413,6 +413,8 @@ computable compute concat cond +conda +Conda Condens conf config @@ -712,6 +714,7 @@ Eike eim eimp Eindhoven +Eisenforschung Ejtehadi El elaplong @@ -930,6 +933,7 @@ funcs functionalities functionals funroll +für fx fy fz @@ -1175,6 +1179,7 @@ initio initializations InP inregion +Institut integrators Integrators intel @@ -1251,6 +1256,7 @@ Jacobsen jagreat Jalalvand james +Janssen Janssens Jaramillo Jarzynski @@ -1543,6 +1549,7 @@ Mackay Mackrodt Macromolecules macroparticle +macOS Madura Magda Magdeburg From 22a033f5d414bb9c993fa02f9c78acfb08625d9c Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Mon, 11 Nov 2019 15:32:09 -0500 Subject: [PATCH 377/557] Move compute_gyration_shape_chunk.txt into txt/ folder --- doc/{src => txt}/compute_gyration_shape_chunk.txt | 0 1 file changed, 0 insertions(+), 0 deletions(-) rename doc/{src => txt}/compute_gyration_shape_chunk.txt (100%) diff --git a/doc/src/compute_gyration_shape_chunk.txt b/doc/txt/compute_gyration_shape_chunk.txt similarity index 100% rename from doc/src/compute_gyration_shape_chunk.txt rename to doc/txt/compute_gyration_shape_chunk.txt From 0018a88f459463bb5dcd1fb10f9b7444c30817bf Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Mon, 11 Nov 2019 15:32:48 -0500 Subject: [PATCH 378/557] Only keep RST version of compute_gyration_shape_chunk --- doc/src/compute_gyration_shape_chunk.rst | 113 +++++++++++++++++++++++ doc/txt/compute_gyration_shape_chunk.txt | 93 ------------------- 2 files changed, 113 insertions(+), 93 deletions(-) create mode 100644 doc/src/compute_gyration_shape_chunk.rst delete mode 100644 doc/txt/compute_gyration_shape_chunk.txt diff --git a/doc/src/compute_gyration_shape_chunk.rst b/doc/src/compute_gyration_shape_chunk.rst new file mode 100644 index 0000000000..fa839aea35 --- /dev/null +++ b/doc/src/compute_gyration_shape_chunk.rst @@ -0,0 +1,113 @@ +.. index:: compute gyration/shape/chunk + +compute gyration/shape/chunk command +==================================== + +Syntax +"""""" + + +.. parsed-literal:: + + compute ID group-ID gyration/shape/chunk compute-ID + +* ID, group-ID are documented in :doc:`compute ` command +* gyration/shape/chunk = style name of this compute command +* compute-ID = ID of :doc:`compute gyration/chunk ` command + +Examples +"""""""" + + +.. parsed-literal:: + + compute 1 molecule gyration/shape/chunk pe + +Description +""""""""""" + +Define a computation that calculates the eigenvalues of the gyration tensor and +three shape parameters of multiple chunks of atoms. The computation includes +all effects due to atoms passing through periodic boundaries. + +The three computed shape parameters are the asphericity, b, the acylindricity, c, +and the relative shape anisotropy, k: + +.. image:: Eqs/compute_shape_parameters.jpg + :align: center + +where lx <= ly <= lz are the three eigenvalues of the gyration tensor. A general description +of these parameters is provided in :ref:`(Mattice) ` while an application to polymer systems +can be found in :ref:`(Theodorou) `. 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). + +The tensor keyword must be specified in the compute gyration/chunk command. + +.. 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 :doc:`dump custom ` command for a discussion of "unwrapped" + coordinates. See the Atoms section of the :doc:`read\_data ` + 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 :doc:`set image ` command. + +**Output info:** + +This compute calculates a global array with six columns, +which can be accessed by indices 1-6. The first three columns 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 array values from a compute as input. See the :doc:`Howto output ` doc page for an overview of LAMMPS output +options. + +The array calculated by this compute is +"intensive". The first five columns will be in +distance\^2 :doc:`units ` 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 :doc:`Build package ` doc page for more info. + +Related commands +"""""""""""""""" + +:doc:`compute gyration/chunk ` +:doc:`compute gyration/shape ` + +**Default:** none + + +---------- + + +.. _Mattice2: + + + +**(Mattice)** Mattice, Suter, Conformational Theory of Large Molecules, Wiley, New York, 1994. + +.. _Theodorou2: + + + +**(Theodorou)** Theodorou, Suter, Macromolecules, 18, 1206 (1985). + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/doc/txt/compute_gyration_shape_chunk.txt b/doc/txt/compute_gyration_shape_chunk.txt deleted file mode 100644 index c74d571007..0000000000 --- a/doc/txt/compute_gyration_shape_chunk.txt +++ /dev/null @@ -1,93 +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 - -compute gyration/shape/chunk command :h3 - -[Syntax:] - -compute ID group-ID gyration/shape/chunk compute-ID :pre - -ID, group-ID are documented in "compute"_compute.html command -gyration/shape/chunk = style name of this compute command -compute-ID = ID of "compute gyration/chunk"_compute_gyration_chunk.html command :ul - -[Examples:] - -compute 1 molecule gyration/shape/chunk pe :pre - -[Description:] - -Define a computation that calculates the eigenvalues of the gyration tensor and -three shape parameters of multiple chunks of atoms. The computation includes -all effects due to atoms passing through 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. A general description -of these parameters is provided in "(Mattice)"_#Mattice2 while an application to polymer systems -can be found in "(Theodorou)"_#Theodorou2. 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). - -The tensor keyword must be specified in the compute gyration/chunk command. - -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 array with six columns, -which can be accessed by indices 1-6. The first three columns 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 array values from a compute as input. See the "Howto -output"_Howto_output.html doc page for an overview of LAMMPS output -options. - -The array calculated by this compute is -"intensive". The first five columns 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/chunk"_compute_gyration_chunk.html -"compute gyration/shape"_compute_gyration_shape.html - -[Default:] none - -:line - -:link(Mattice2) -[(Mattice)] Mattice, Suter, Conformational Theory of Large Molecules, Wiley, New York, 1994. - -:link(Theodorou2) -[(Theodorou)] Theodorou, Suter, Macromolecules, 18, 1206 (1985). - From b65a3e94a796bd82b0393c007e98bd120d747f05 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Tue, 12 Nov 2019 22:43:52 +0900 Subject: [PATCH 379/557] update compute heat/flux documentation --- doc/src/compute_heat_flux.rst | 92 +++++++++++++++++++++++++---------- 1 file changed, 67 insertions(+), 25 deletions(-) diff --git a/doc/src/compute_heat_flux.rst b/doc/src/compute_heat_flux.rst index 9642582c5e..df98c85b64 100644 --- a/doc/src/compute_heat_flux.rst +++ b/doc/src/compute_heat_flux.rst @@ -54,38 +54,58 @@ third calculates per-atom stress (\ *stress-ID*\ ). (or any group whose atoms are superset of the atoms in this compute's group). LAMMPS does not check for this. -The Green-Kubo formulas relate the ensemble average of the -auto-correlation of the heat flux J to the thermal conductivity kappa: +In case of pairwise interactions the heat flux is defined as: -.. image:: Eqs/heat_flux_J.jpg - :align: center +.. math:: + \mathbf{J} &= \frac{1}{V} \left[ \sum_i e_i \mathbf{v}_i - \sum_{i} \mathbf{S}_{i} \mathbf{v}_i \right] \\ + &= \frac{1}{V} \left[ \sum_i e_i \mathbf{v}_i + \sum_{i` +and :doc:`compute centroid/stress/atom ` +for possible definitions of atomic stress :math:`\mathbf{S}_i` +in the case of thee-body and larger many-body interactions. +The tensor multiplies :math:`\mathbf{v}_i` as a 3x3 matrix-vector multiply +to yield a vector. +Note that as discussed below, the :math:`\frac{1}{V}` scaling factor in the +equation for :math:`\mathbf{J}` is NOT included in the calculation performed by +these computes; you need to add it for a volume appropriate to the atoms included in the calculation. .. note:: - The :doc:`compute pe/atom ` and :doc:`compute stress/atom ` commands have options for which + The :doc:`compute pe/atom ` and + :doc:`compute stress/atom ` + commands have options for which terms to include in their calculation (pair, bond, etc). The heat - flux calculation will thus include exactly the same terms. Normally + flux calculation will thus include exactly the same terms. Normally you should use :doc:`compute stress/atom virial ` + or :doc:`compute centroid/stress/atom virial ` so as not to include a kinetic energy term in the heat flux. -This compute calculates 6 quantities and stores them in a 6-component -vector. The first 3 components are the x, y, z components of the full -heat flux vector, i.e. (Jx, Jy, Jz). The next 3 components are the x, -y, z components of just the convective portion of the flux, i.e. the -first term in the equation for J above. + +.. warning:: + + The compute *heat/flux* has been reported to produce unphysical + values for three and larger many-body interactions such + as angles, dihedrals and torsions, + when used with :doc:`compute stress/atom `, + as discussed in :ref:`(Surblys) ` and :ref:`(Boone) `. + You are strongly advised to + use :doc:`compute centroid/stress/atom `, + which has been implemented specifically for such cases. + +The Green-Kubo formulas relate the ensemble average of the +auto-correlation of the heat flux :math:`\mathbf{J}` +to the thermal conductivity :math:`\kappa`: + +.. math:: + \kappa = \frac{V}{k_B T^2} \int_0^\infty \langle J_x(0) J_x(t) \rangle \, \mathrm{d} t = \frac{V}{3 k_B T^2} \int_0^\infty \langle \mathbf{J}(0) \cdot \mathbf{J}(t) \rangle \, \mathrm{d}t ---------- @@ -109,9 +129,15 @@ result should be: average conductivity ~0.29 in W/mK. **Output info:** -This compute calculates a global vector of length 6 (total heat flux -vector, followed by convective heat flux vector), which can be -accessed by indices 1-6. These values can be used by any command that +This compute calculates a global vector of length 6. +The first 3 components are the :math:`x`, :math:`y`, :math:`z` +components of the full heat flux vector, +i.e. (:math:`J_x`, :math:`J_y`, :math:`J_z`). +The next 3 components are the :math:`x`, :math:`y`, :math:`z` components +of just the convective portion of the flux, i.e. the +first term in the equation for :math:`\mathbf{J}`. +Each component can be +accessed by indices 1-6. These values can be used by any command that uses global vector values from a compute as input. See the :doc:`Howto output ` doc page for an overview of LAMMPS output options. @@ -212,6 +238,22 @@ Related commands print "average conductivity: $k[W/mK] @ $T K, ${ndens} /A\^3" +---------- + + +.. _Surblys2: + + + +**(Surblys)** Surblys, Matsubara, Kikugawa, Ohara, Phys Rev E, 99, 051301(R) (2019). + +.. _Boone: + + + +**(Boone)** Boone, Babaei, Wilmer, J Chem Theory Comput, 15, 5579--5587 (2019). + + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Commands_all.html From b6930cbc8d4265e6dd460af2ee6b4e789c0d308d Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Tue, 12 Nov 2019 23:34:03 +0900 Subject: [PATCH 380/557] Add author names to false positives for citation "Surblys, Matsubara, Kikugawa, Ohara, Phys Rev E, 99, 051301(R) (2019)." --- 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 5b3020c7d1..cc04ded2fd 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -1340,6 +1340,7 @@ Khersonskii Khrapak Khvostov Ki +Kikugawa kim kJ kk @@ -1594,6 +1595,7 @@ Materias mathbf matlab matplotlib +Matsubara Mattice Mattox Mattson @@ -2017,6 +2019,7 @@ Nz ocl octahedral octants +Ohara ohenrich ok Okabe @@ -2688,6 +2691,7 @@ Sunderland superset supersphere Supinski +Surblys surfactants Suter Sutmann From 2d75e6b167892d64d68f3d638c19957b88c83c2e Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Tue, 12 Nov 2019 23:37:14 +0900 Subject: [PATCH 381/557] =?UTF-8?q?Add=20author=20name=20to=20false=20posi?= =?UTF-8?q?tives=20for=20citation=20"Boone,=20Babaei,=20Wilmer,=20J=20Chem?= =?UTF-8?q?=20Theory=20Comput,=2015,=205579=E2=80=935587=20(2019)."?= MIME-Version: 1.0 Content-Type: text/plain; charset=UTF-8 Content-Transfer-Encoding: 8bit --- 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 cc04ded2fd..6ab81a141e 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -164,6 +164,7 @@ azimuthal Azuri ba Babadi +Babaei backcolor Baczewski Bagi From 1955c57791b276f580f83eafe9eb5567ee3fab2d Mon Sep 17 00:00:00 2001 From: Steve Plimpton Date: Tue, 12 Nov 2019 10:16:50 -0700 Subject: [PATCH 382/557] make fix print work the same for run, multiple runs, rerun --- src/fix_print.cpp | 16 +++++++++++++--- src/fix_print.h | 1 + 2 files changed, 14 insertions(+), 3 deletions(-) diff --git a/src/fix_print.cpp b/src/fix_print.cpp index f6a45017fb..67f164e05e 100644 --- a/src/fix_print.cpp +++ b/src/fix_print.cpp @@ -134,7 +134,10 @@ void FixPrint::init() if (next_print <= update->ntimestep) error->all(FLERR,"Fix print timestep variable returned a bad timestep"); } else { - next_print = (update->ntimestep/nevery)*nevery + nevery; + if (update->ntimestep % nevery) + next_print = (update->ntimestep/nevery)*nevery + nevery; + else + next_print = update->ntimestep; } // add next_print to all computes that store invocation times @@ -146,10 +149,16 @@ void FixPrint::init() /* ---------------------------------------------------------------------- */ +void FixPrint::setup(int vflag) +{ + end_of_step(); +} + +/* ---------------------------------------------------------------------- */ + void FixPrint::end_of_step() { - //Only execute if we have advanced one step (normal run) or we are on the same step (rerun) - if ((update->ntimestep != next_print) & (update->ntimestep != next_print-nevery)) return; + if (update->ntimestep != next_print) return; // make a copy of string to work on // substitute for $ variables (no printing) @@ -169,6 +178,7 @@ void FixPrint::end_of_step() } else { next_print = (update->ntimestep/nevery)*nevery + nevery; } + modify->addstep_compute(next_print); if (me == 0) { diff --git a/src/fix_print.h b/src/fix_print.h index 5644160220..6ee39318e8 100644 --- a/src/fix_print.h +++ b/src/fix_print.h @@ -29,6 +29,7 @@ class FixPrint : public Fix { FixPrint(class LAMMPS *, int, char **); ~FixPrint(); void init(); + void setup(int); int setmask(); void end_of_step(); From 25e2a7a37f32a73efe8b67a2e10dee2edceb5635 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 12 Nov 2019 14:25:45 -0500 Subject: [PATCH 383/557] update bond style table docs about out-of-range errors --- doc/src/bond_table.rst | 5 +- doc/txt/bond_table.txt | 163 ----------------------------------------- 2 files changed, 3 insertions(+), 165 deletions(-) delete mode 100644 doc/txt/bond_table.txt diff --git a/doc/src/bond_table.rst b/doc/src/bond_table.rst index f68288349d..d0ea609aff 100644 --- a/doc/src/bond_table.rst +++ b/doc/src/bond_table.rst @@ -119,8 +119,9 @@ the bond length r (in distance units), the 3rd value is the energy (in energy units), and the 4th is the force (in force units). The bond lengths must range from a LO value to a HI value, and increase from one line to the next. If the actual bond length is ever smaller than -the LO value or larger than the HI value, then the bond energy and -force is evaluated as if the bond were the LO or HI length. +the LO value or larger than the HI value, then the calculation is +aborted with an error, so it is advisable to cover the whole range +of possible bond lengths. Note that one file can contain many sections, each with a tabulated potential. LAMMPS reads the file section by section until it finds diff --git a/doc/txt/bond_table.txt b/doc/txt/bond_table.txt deleted file mode 100644 index 7235214af0..0000000000 --- a/doc/txt/bond_table.txt +++ /dev/null @@ -1,163 +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 - -bond_style table command :h3 -bond_style table/omp command :h3 - -[Syntax:] - -bond_style table style N :pre - -style = {linear} or {spline} = method of interpolation -N = use N values in table :ul - -[Examples:] - -bond_style table linear 1000 -bond_coeff 1 file.table ENTRY1 :pre - -[Description:] - -Style {table} creates interpolation tables of length {N} from bond -potential and force values listed in a file(s) as a function of bond -length. The files are read by the "bond_coeff"_bond_coeff.html -command. - -The interpolation tables are created by fitting cubic splines to the -file values and interpolating energy and force values at each of {N} -distances. During a simulation, these tables are used to interpolate -energy and force values as needed. The interpolation is done in one -of 2 styles: {linear} or {spline}. - -For the {linear} style, the bond length is used to find 2 surrounding -table values from which an energy or force is computed by linear -interpolation. - -For the {spline} style, a cubic spline coefficients are computed and -stored at each of the {N} values in the table. The bond length is -used to find the appropriate set of coefficients which are used to -evaluate a cubic polynomial which computes the energy or force. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above. - -filename -keyword :ul - -The filename specifies a file containing tabulated energy and force -values. The keyword specifies a section of the file. The format of -this file is described below. - -:line - -The format of a tabulated file is as follows (without the -parenthesized comments): - -# Bond potential for harmonic (one or more comment or blank lines) :pre - -HAM (keyword is the first text on line) -N 101 FP 0 0 EQ 0.5 (N, FP, EQ parameters) - (blank line) -1 0.00 338.0000 1352.0000 (index, bond-length, energy, force) -2 0.01 324.6152 1324.9600 -... -101 1.00 338.0000 -1352.0000 :pre - -A section begins with a non-blank line whose 1st character is not a -"#"; blank lines or lines starting with "#" can be used as comments -between sections. The first line begins with a keyword which -identifies the section. The line can contain additional text, but the -initial text must match the argument specified in the -"bond_coeff"_bond_coeff.html command. The next line lists (in any -order) one or more parameters for the table. Each parameter is a -keyword followed by one or more numeric values. - -The parameter "N" is required and its value is the number of table -entries that follow. Note that this may be different than the {N} -specified in the "bond_style table"_bond_style.html command. Let -Ntable = {N} in the bond_style command, and Nfile = "N" in the -tabulated file. What LAMMPS does is a preliminary interpolation by -creating splines using the Nfile tabulated values as nodal points. It -uses these to interpolate as needed to generate energy and force -values at Ntable different points. The resulting tables of length -Ntable are then used as described above, when computing energy and -force for individual bond lengths. This means that if you want the -interpolation tables of length Ntable to match exactly what is in the -tabulated file (with effectively no preliminary interpolation), you -should set Ntable = Nfile. - -The "FP" parameter is optional. If used, it is followed by two values -fplo and fphi, which are the derivatives of the force at the innermost -and outermost bond lengths. These values are needed by the spline -construction routines. If not specified by the "FP" parameter, they -are estimated (less accurately) by the first two and last two force -values in the table. - -The "EQ" parameter is also optional. If used, it is followed by a the -equilibrium bond length, which is used, for example, by the "fix -shake"_fix_shake.html command. If not used, the equilibrium bond -length is to the distance in the table with the lowest potential energy. - -Following a blank line, the next N lines list the tabulated values. -On each line, the 1st value is the index from 1 to N, the 2nd value is -the bond length r (in distance units), the 3rd value is the energy (in -energy units), and the 4th is the force (in force units). The bond -lengths must range from a LO value to a HI value, and increase from -one line to the next. If the actual bond length is ever smaller than -the LO value or larger than the HI value, then the bond energy and -force is evaluated as if the bond were the LO or HI length. - -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. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -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 -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From f704079fb7eb7d5673e5f2c79431d4c9f69f179e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 12 Nov 2019 16:13:01 -0500 Subject: [PATCH 384/557] remove trailing whitespace --- src/GRANULAR/fix_pour.cpp | 4 ++-- src/MC/fix_gcmc.cpp | 6 +++--- src/USER-MISC/compute_gyration_shape_chunk.cpp | 2 +- 3 files changed, 6 insertions(+), 6 deletions(-) diff --git a/src/GRANULAR/fix_pour.cpp b/src/GRANULAR/fix_pour.cpp index 2b33b988b8..2255f64eb2 100644 --- a/src/GRANULAR/fix_pour.cpp +++ b/src/GRANULAR/fix_pour.cpp @@ -54,7 +54,7 @@ FixPour::FixPour(LAMMPS *lmp, int narg, char **arg) : { if (narg < 6) error->all(FLERR,"Illegal fix pour command"); - if (lmp->kokkos) + if (lmp->kokkos) error->all(FLERR,"Cannot yet use fix pour with the KOKKOS package"); time_depend = 1; @@ -797,7 +797,7 @@ bool FixPour::outside(int dim, double value, double lo, double hi) bool outside_range = (value < lo || value > hi); if (!outside_range || !domain->periodicity[dim]) return outside_range; - // for periodic dimension: + // for periodic dimension: // must perform additional tests if range wraps around the periodic box bool outside_pbc_range = true; diff --git a/src/MC/fix_gcmc.cpp b/src/MC/fix_gcmc.cpp index 516fe2521d..732e76b77e 100644 --- a/src/MC/fix_gcmc.cpp +++ b/src/MC/fix_gcmc.cpp @@ -945,7 +945,7 @@ void FixGCMC::attempt_atomic_insertion() ninsertion_attempts += 1.0; if (ngas >= max_ngas) return; - + // pick coordinates for insertion point double coord[3]; @@ -1300,7 +1300,7 @@ void FixGCMC::attempt_molecule_insertion() ninsertion_attempts += 1.0; if (ngas >= max_ngas) return; - + double com_coord[3]; if (regionflag) { int region_attempt = 0; @@ -1634,7 +1634,7 @@ void FixGCMC::attempt_atomic_insertion_full() ninsertion_attempts += 1.0; if (ngas >= max_ngas) return; - + double energy_before = energy_stored; double coord[3]; diff --git a/src/USER-MISC/compute_gyration_shape_chunk.cpp b/src/USER-MISC/compute_gyration_shape_chunk.cpp index 08484d9301..b493455ebf 100644 --- a/src/USER-MISC/compute_gyration_shape_chunk.cpp +++ b/src/USER-MISC/compute_gyration_shape_chunk.cpp @@ -39,7 +39,7 @@ ComputeGyrationShapeChunk::ComputeGyrationShapeChunk(LAMMPS *lmp, int narg, char int n = strlen(arg[3]) + 1; id_gyration_chunk = new char[n]; strcpy(id_gyration_chunk,arg[3]); - + init(); array_flag = 1; From f1e4f98364bbc4085c1152210fead1732c5f9b0f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 13 Nov 2019 01:04:39 -0500 Subject: [PATCH 385/557] include embedding energy term in PairEAM::single() --- src/MANYBODY/pair_eam.cpp | 19 ++++++++++++++++++- src/MANYBODY/pair_eam.h | 1 + 2 files changed, 19 insertions(+), 1 deletion(-) diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp index 2e118088eb..9d8b0999b5 100644 --- a/src/MANYBODY/pair_eam.cpp +++ b/src/MANYBODY/pair_eam.cpp @@ -43,6 +43,7 @@ PairEAM::PairEAM(LAMMPS *lmp) : Pair(lmp) nmax = 0; rho = NULL; fp = NULL; + need_embed = NULL; map = NULL; type2frho = NULL; @@ -77,6 +78,7 @@ PairEAM::~PairEAM() memory->destroy(rho); memory->destroy(fp); + memory->destroy(need_embed); if (allocated) { memory->destroy(setflag); @@ -151,9 +153,11 @@ void PairEAM::compute(int eflag, int vflag) if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); + memory->destroy(need_embed); nmax = atom->nmax; memory->create(rho,nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); + memory->create(need_embed,nmax,"pair:need_embed"); } double **x = atom->x; @@ -230,6 +234,7 @@ void PairEAM::compute(int eflag, int vflag) p = MIN(p,1.0); coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; + need_embed[i] = 1; if (eflag) { phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -802,6 +807,18 @@ double PairEAM::single(int i, int j, int itype, int jtype, double r,p,rhoip,rhojp,z2,z2p,recip,phi,phip,psip; double *coeff; + if (need_embed[i]) { + p = rho[i]*rdrho + 1.0; + m = static_cast (p); + m = MAX(1,MIN(m,nrho-1)); + p -= m; + p = MIN(p,1.0); + coeff = frho_spline[type2frho[itype]][m]; + phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; + if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); + need_embed[i] = 0; + } else phi = 0.0; + r = sqrt(rsq); p = r*rdr + 1.0; m = static_cast (p); @@ -818,7 +835,7 @@ double PairEAM::single(int i, int j, int itype, int jtype, z2 = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; recip = 1.0/r; - phi = z2*recip; + phi += z2*recip; phip = z2p*recip - phi*recip; psip = fp[i]*rhojp + fp[j]*rhoip + phip; fforce = -psip*recip; diff --git a/src/MANYBODY/pair_eam.h b/src/MANYBODY/pair_eam.h index 8bcb44c347..d55aea0f11 100644 --- a/src/MANYBODY/pair_eam.h +++ b/src/MANYBODY/pair_eam.h @@ -70,6 +70,7 @@ class PairEAM : public Pair { // per-atom arrays double *rho,*fp; + int *need_embed; // potentials as file data From e0646b73e3e6d789ff05f973c1a20713ae8a609d Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Wed, 13 Nov 2019 01:32:57 -0500 Subject: [PATCH 386/557] revised implementation of inclusion of embedding energy in PairEAM::single() this variant is also ported to USER-OMP and OPT --- src/MANYBODY/pair_eam.cpp | 15 ++++++++------- src/MANYBODY/pair_eam.h | 2 +- src/OPT/pair_eam_opt.cpp | 12 ++++++++---- src/USER-OMP/pair_eam_omp.cpp | 4 ++++ 4 files changed, 21 insertions(+), 12 deletions(-) diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp index 9d8b0999b5..8913b1e9cc 100644 --- a/src/MANYBODY/pair_eam.cpp +++ b/src/MANYBODY/pair_eam.cpp @@ -43,7 +43,7 @@ PairEAM::PairEAM(LAMMPS *lmp) : Pair(lmp) nmax = 0; rho = NULL; fp = NULL; - need_embed = NULL; + count_embed = NULL; map = NULL; type2frho = NULL; @@ -78,7 +78,7 @@ PairEAM::~PairEAM() memory->destroy(rho); memory->destroy(fp); - memory->destroy(need_embed); + memory->destroy(count_embed); if (allocated) { memory->destroy(setflag); @@ -153,11 +153,11 @@ void PairEAM::compute(int eflag, int vflag) if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); - memory->destroy(need_embed); + memory->destroy(count_embed); nmax = atom->nmax; memory->create(rho,nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); - memory->create(need_embed,nmax,"pair:need_embed"); + memory->create(count_embed,nmax,"pair:count_embed"); } double **x = atom->x; @@ -234,7 +234,7 @@ void PairEAM::compute(int eflag, int vflag) p = MIN(p,1.0); coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; - need_embed[i] = 1; + count_embed[i] = 0; if (eflag) { phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -271,6 +271,7 @@ void PairEAM::compute(int eflag, int vflag) rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutforcesq) { + ++count_embed[i]; jtype = type[j]; r = sqrt(rsq); p = r*rdr + 1.0; @@ -807,7 +808,7 @@ double PairEAM::single(int i, int j, int itype, int jtype, double r,p,rhoip,rhojp,z2,z2p,recip,phi,phip,psip; double *coeff; - if (need_embed[i]) { + if (count_embed[i] > 0) { p = rho[i]*rdrho + 1.0; m = static_cast (p); m = MAX(1,MIN(m,nrho-1)); @@ -816,7 +817,7 @@ double PairEAM::single(int i, int j, int itype, int jtype, coeff = frho_spline[type2frho[itype]][m]; phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); - need_embed[i] = 0; + phi *= 1.0/static_cast(count_embed[i]); } else phi = 0.0; r = sqrt(rsq); diff --git a/src/MANYBODY/pair_eam.h b/src/MANYBODY/pair_eam.h index d55aea0f11..3f135aaa1f 100644 --- a/src/MANYBODY/pair_eam.h +++ b/src/MANYBODY/pair_eam.h @@ -70,7 +70,7 @@ class PairEAM : public Pair { // per-atom arrays double *rho,*fp; - int *need_embed; + int *count_embed; // potentials as file data diff --git a/src/OPT/pair_eam_opt.cpp b/src/OPT/pair_eam_opt.cpp index ad24aaee63..dbea720488 100644 --- a/src/OPT/pair_eam_opt.cpp +++ b/src/OPT/pair_eam_opt.cpp @@ -80,11 +80,13 @@ void PairEAMOpt::eval() // grow energy array if necessary if (atom->nmax > nmax) { - memory->sfree(rho); - memory->sfree(fp); + memory->destroy(rho); + memory->destroy(fp); + memory->destroy(count_embed); nmax = atom->nmax; - rho = (double *) memory->smalloc(nmax*sizeof(double),"pair:rho"); - fp = (double *) memory->smalloc(nmax*sizeof(double),"pair:fp"); + memory->create(rho,nmax,"pair:rho"); + memory->create(fp,nmax,"pair:fp"); + memory->create(count_embed,nmax,"pair:count_embed"); } double** _noalias x = atom->x; @@ -238,6 +240,7 @@ void PairEAMOpt::eval() ++m; coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; + count_embed[i] = 0; if (EFLAG) { double phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -280,6 +283,7 @@ void PairEAMOpt::eval() double rsq = delx*delx + dely*dely + delz*delz; if (rsq < tmp_cutforcesq) { + ++count_embed[i]; jtype = type[j] - 1; double r = sqrt(rsq); double rhoip,rhojp,z2,z2p; diff --git a/src/USER-OMP/pair_eam_omp.cpp b/src/USER-OMP/pair_eam_omp.cpp index 99417f27da..1b48214ed4 100644 --- a/src/USER-OMP/pair_eam_omp.cpp +++ b/src/USER-OMP/pair_eam_omp.cpp @@ -51,9 +51,11 @@ void PairEAMOMP::compute(int eflag, int vflag) if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); + memory->destroy(count_embed); nmax = atom->nmax; memory->create(rho,nthreads*nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); + memory->create(count_embed,nmax,"pair:count_embed"); } #if defined(_OPENMP) @@ -198,6 +200,7 @@ void PairEAMOMP::eval(int iifrom, int iito, ThrData * const thr) p = MIN(p,1.0); coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; + count_embed[i] = 0; if (EFLAG) { phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -243,6 +246,7 @@ void PairEAMOMP::eval(int iifrom, int iito, ThrData * const thr) rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutforcesq) { + ++count_embed[i]; jtype = type[j]; r = sqrt(rsq); p = r*rdr + 1.0; From 6b94126f67a9032671c533927de540e35d7f01bd Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 18:37:48 +0900 Subject: [PATCH 387/557] change flag name in pair.h: cntratmstressflag -> centroidstressflag --- src/CLASS2/pair_lj_class2.cpp | 2 +- src/CLASS2/pair_lj_class2_coul_cut.cpp | 2 +- src/PYTHON/pair_python.cpp | 2 +- src/USER-FEP/pair_coul_cut_soft.cpp | 2 +- src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp | 2 +- src/USER-FEP/pair_lj_class2_soft.cpp | 2 +- src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp | 2 +- src/USER-FEP/pair_lj_cut_soft.cpp | 2 +- src/USER-OMP/thr_omp.cpp | 6 +++--- src/compute_centroid_stress_atom.cpp | 4 ++-- src/pair.cpp | 6 +++--- src/pair.h | 2 +- src/pair_beck.cpp | 2 +- src/pair_buck.cpp | 2 +- src/pair_buck_coul_cut.cpp | 2 +- src/pair_coul_cut.cpp | 2 +- src/pair_coul_dsf.cpp | 2 +- src/pair_coul_wolf.cpp | 2 +- src/pair_hybrid.cpp | 6 +++--- 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_dsf.cpp | 2 +- src/pair_lj_cut_coul_wolf.cpp | 2 +- src/pair_lj_expand.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_morse.cpp | 2 +- src/pair_ufm.cpp | 2 +- 30 files changed, 37 insertions(+), 37 deletions(-) diff --git a/src/CLASS2/pair_lj_class2.cpp b/src/CLASS2/pair_lj_class2.cpp index a304390b5d..47b3185bbf 100644 --- a/src/CLASS2/pair_lj_class2.cpp +++ b/src/CLASS2/pair_lj_class2.cpp @@ -35,7 +35,7 @@ PairLJClass2::PairLJClass2(LAMMPS *lmp) : Pair(lmp) { respa_enable = 1; writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/CLASS2/pair_lj_class2_coul_cut.cpp b/src/CLASS2/pair_lj_class2_coul_cut.cpp index c1d5253d9a..3635c21c8c 100644 --- a/src/CLASS2/pair_lj_class2_coul_cut.cpp +++ b/src/CLASS2/pair_lj_class2_coul_cut.cpp @@ -33,7 +33,7 @@ using namespace MathConst; PairLJClass2CoulCut::PairLJClass2CoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/PYTHON/pair_python.cpp b/src/PYTHON/pair_python.cpp index 819f125496..8fbb3e6f8b 100644 --- a/src/PYTHON/pair_python.cpp +++ b/src/PYTHON/pair_python.cpp @@ -40,7 +40,7 @@ PairPython::PairPython(LAMMPS *lmp) : Pair(lmp) { one_coeff = 1; reinitflag = 0; cut_global = 0.0; - cntratmstressflag = 1; + centroidstressflag = 1; py_potential = NULL; skip_types = NULL; diff --git a/src/USER-FEP/pair_coul_cut_soft.cpp b/src/USER-FEP/pair_coul_cut_soft.cpp index bed357d663..eb872ab8b9 100644 --- a/src/USER-FEP/pair_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_coul_cut_soft.cpp @@ -33,7 +33,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ PairCoulCutSoft::PairCoulCutSoft(LAMMPS *lmp) : Pair(lmp) { - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ 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 c7319d574c..255bdf6a07 100644 --- a/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_coul_cut_soft.cpp @@ -33,7 +33,7 @@ using namespace MathConst; PairLJClass2CoulCutSoft::PairLJClass2CoulCutSoft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-FEP/pair_lj_class2_soft.cpp b/src/USER-FEP/pair_lj_class2_soft.cpp index 7b8cdeb29c..957fc0f8ab 100644 --- a/src/USER-FEP/pair_lj_class2_soft.cpp +++ b/src/USER-FEP/pair_lj_class2_soft.cpp @@ -32,7 +32,7 @@ using namespace MathConst; PairLJClass2Soft::PairLJClass2Soft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ 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 42ce3fe44d..3f85a2c8aa 100644 --- a/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_coul_cut_soft.cpp @@ -37,7 +37,7 @@ using namespace MathConst; PairLJCutCoulCutSoft::PairLJCutCoulCutSoft(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-FEP/pair_lj_cut_soft.cpp b/src/USER-FEP/pair_lj_cut_soft.cpp index bcbf2770ad..9d03b4e1e2 100644 --- a/src/USER-FEP/pair_lj_cut_soft.cpp +++ b/src/USER-FEP/pair_lj_cut_soft.cpp @@ -43,7 +43,7 @@ PairLJCutSoft::PairLJCutSoft(LAMMPS *lmp) : Pair(lmp) respa_enable = 1; writedata = 1; allocated = 0; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/USER-OMP/thr_omp.cpp b/src/USER-OMP/thr_omp.cpp index ca754b9732..b6115ffe2a 100644 --- a/src/USER-OMP/thr_omp.cpp +++ b/src/USER-OMP/thr_omp.cpp @@ -82,7 +82,7 @@ void ThrOMP::ev_setup_thr(int eflag, int vflag, int nall, double *eatom, if (nall > 0) memset(&(thr->vatom_pair[0][0]),0,nall*6*sizeof(double)); } - // check cvatom_pair, because can't access cntratmstressflag + // check cvatom_pair, because can't access centroidstressflag if ((vflag & 8) && cvatom) { thr->cvatom_pair = cvatom + tid*nall; if (nall > 0) @@ -243,7 +243,7 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); } - // check cvatom_pair, because can't access cntratmstressflag + // check cvatom_pair, because can't access centroidstressflag if ((vflag & 8) && thr->cvatom_pair) { data_reduce_thr(&(pair->cvatom[0][0]), nall, nthreads, 9, tid); } @@ -394,7 +394,7 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); } - // check cvatom_pair, because can't access cntratmstressflag + // check cvatom_pair, because can't access centroidstressflag if ((vflag & 8) && thr->cvatom_pair) { data_reduce_thr(&(pair->cvatom[0][0]), nall, nthreads, 9, tid); } diff --git a/src/compute_centroid_stress_atom.cpp b/src/compute_centroid_stress_atom.cpp index dfab2b878a..e623719841 100644 --- a/src/compute_centroid_stress_atom.cpp +++ b/src/compute_centroid_stress_atom.cpp @@ -126,7 +126,7 @@ void ComputeCentroidStressAtom::init() // check if pair styles support centroid atom stress if (pairflag && force->pair) - if (force->pair->cntratmstressflag & 4) + if (force->pair->centroidstressflag & 4) error->all(FLERR, "Pair style does not support compute centroid/stress/atom"); } @@ -178,7 +178,7 @@ void ComputeCentroidStressAtom::compute_peratom() // per-atom virial and per-atom centroid virial are the same for pairwise // many-body pair styles not yet implemented if (pairflag && force->pair) { - if (force->pair->cntratmstressflag & 2) { + if (force->pair->centroidstressflag & 2) { double **cvatom = force->pair->cvatom; for (i = 0; i < npair; i++) for (j = 0; j < 9; j++) diff --git a/src/pair.cpp b/src/pair.cpp index d3f67019df..d27991678c 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -72,7 +72,7 @@ Pair::Pair(LAMMPS *lmp) : Pointers(lmp) ewaldflag = pppmflag = msmflag = dispersionflag = tip4pflag = dipoleflag = spinflag = 0; reinitflag = 1; - cntratmstressflag = 4; + centroidstressflag = 4; // pair_modify settings @@ -786,13 +786,13 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) vflag_atom = vflag & 4; if (vflag & 8) { - if (cntratmstressflag & 2) { + if (centroidstressflag & 2) { cvflag_atom = 1; } else { vflag_atom = 1; } // extra check, because both bits might be set - if (cntratmstressflag & 1) vflag_atom = 1; + if (centroidstressflag & 1) vflag_atom = 1; } vflag_either = vflag_global || vflag_atom; diff --git a/src/pair.h b/src/pair.h index d28ed60827..aaab77d700 100644 --- a/src/pair.h +++ b/src/pair.h @@ -66,7 +66,7 @@ class Pair : protected Pointers { int spinflag; // 1 if compatible with spin solver int reinitflag; // 1 if compatible with fix adapt and alike - int cntratmstressflag; // compatibility with centroid atomic stress + int centroidstressflag; // compatibility with centroid atomic stress // 1 if same as pairwise atomic stress // 2 if implemented and different from pairwise // 4 if not compatible/implemented diff --git a/src/pair_beck.cpp b/src/pair_beck.cpp index 981dd5026d..31dd2ef62f 100644 --- a/src/pair_beck.cpp +++ b/src/pair_beck.cpp @@ -33,7 +33,7 @@ using namespace MathSpecial; /* ---------------------------------------------------------------------- */ PairBeck::PairBeck(LAMMPS *lmp) : Pair(lmp) { - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_buck.cpp b/src/pair_buck.cpp index 9e8c1fac59..6fc1c782e0 100644 --- a/src/pair_buck.cpp +++ b/src/pair_buck.cpp @@ -32,7 +32,7 @@ using namespace MathConst; PairBuck::PairBuck(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_buck_coul_cut.cpp b/src/pair_buck_coul_cut.cpp index 022959eacb..ed0fb1fef8 100644 --- a/src/pair_buck_coul_cut.cpp +++ b/src/pair_buck_coul_cut.cpp @@ -36,7 +36,7 @@ using namespace MathConst; PairBuckCoulCut::PairBuckCoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_cut.cpp b/src/pair_coul_cut.cpp index edefd014ab..a197955085 100644 --- a/src/pair_coul_cut.cpp +++ b/src/pair_coul_cut.cpp @@ -29,7 +29,7 @@ using namespace LAMMPS_NS; /* ---------------------------------------------------------------------- */ PairCoulCut::PairCoulCut(LAMMPS *lmp) : Pair(lmp) { - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_dsf.cpp b/src/pair_coul_dsf.cpp index f43dbb139a..a21bf61afb 100644 --- a/src/pair_coul_dsf.cpp +++ b/src/pair_coul_dsf.cpp @@ -44,7 +44,7 @@ using namespace MathConst; /* ---------------------------------------------------------------------- */ PairCoulDSF::PairCoulDSF(LAMMPS *lmp) : Pair(lmp) { - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_coul_wolf.cpp b/src/pair_coul_wolf.cpp index e5318f43d5..b34877f508 100644 --- a/src/pair_coul_wolf.cpp +++ b/src/pair_coul_wolf.cpp @@ -36,7 +36,7 @@ using namespace MathConst; PairCoulWolf::PairCoulWolf(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; // NOTE: single() method below is not yet correct - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index 0fdca8e416..62c30cd2da 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -43,7 +43,7 @@ PairHybrid::PairHybrid(LAMMPS *lmp) : Pair(lmp), // assume pair hybrid always supports centroid atomic stress, // so that cflag_atom gets set when needed - cntratmstressflag = 2; + centroidstressflag = 2; } /* ---------------------------------------------------------------------- */ @@ -166,7 +166,7 @@ void PairHybrid::compute(int eflag, int vflag) if (cvflag_atom) { n = atom->nlocal; if (force->newton_pair) n += atom->nghost; - if (styles[m]->cntratmstressflag & 2) { + if (styles[m]->centroidstressflag & 2) { double **cvatom_substyle = styles[m]->cvatom; for (i = 0; i < n; i++) for (j = 0; j < 9; j++) @@ -384,7 +384,7 @@ void PairHybrid::flags() if (styles[m]->dispersionflag) dispersionflag = 1; if (styles[m]->tip4pflag) tip4pflag = 1; if (styles[m]->compute_flag) compute_flag = 1; - cntratmstressflag |= styles[m]->cntratmstressflag; + centroidstressflag |= styles[m]->centroidstressflag; } init_svector(); } diff --git a/src/pair_lj_cubic.cpp b/src/pair_lj_cubic.cpp index 392604c558..2af308b2f0 100644 --- a/src/pair_lj_cubic.cpp +++ b/src/pair_lj_cubic.cpp @@ -33,7 +33,7 @@ using namespace PairLJCubicConstants; /* ---------------------------------------------------------------------- */ PairLJCubic::PairLJCubic(LAMMPS *lmp) : Pair(lmp) { - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut.cpp b/src/pair_lj_cut.cpp index 2e1eba2011..e31e275a7d 100644 --- a/src/pair_lj_cut.cpp +++ b/src/pair_lj_cut.cpp @@ -41,7 +41,7 @@ PairLJCut::PairLJCut(LAMMPS *lmp) : Pair(lmp) { respa_enable = 1; writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_cut.cpp b/src/pair_lj_cut_coul_cut.cpp index 1d85fa1745..7f0f89a5bf 100644 --- a/src/pair_lj_cut_coul_cut.cpp +++ b/src/pair_lj_cut_coul_cut.cpp @@ -33,7 +33,7 @@ using namespace MathConst; PairLJCutCoulCut::PairLJCutCoulCut(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_dsf.cpp b/src/pair_lj_cut_coul_dsf.cpp index 2b243990a4..9dc6c001f4 100644 --- a/src/pair_lj_cut_coul_dsf.cpp +++ b/src/pair_lj_cut_coul_dsf.cpp @@ -46,7 +46,7 @@ using namespace MathConst; PairLJCutCoulDSF::PairLJCutCoulDSF(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_cut_coul_wolf.cpp b/src/pair_lj_cut_coul_wolf.cpp index 0f0a7413fa..c69e90f28b 100644 --- a/src/pair_lj_cut_coul_wolf.cpp +++ b/src/pair_lj_cut_coul_wolf.cpp @@ -37,7 +37,7 @@ PairLJCutCoulWolf::PairLJCutCoulWolf(LAMMPS *lmp) : Pair(lmp) { single_enable = 0; writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_expand.cpp b/src/pair_lj_expand.cpp index 988305d394..98c8a808e2 100644 --- a/src/pair_lj_expand.cpp +++ b/src/pair_lj_expand.cpp @@ -32,7 +32,7 @@ using namespace MathConst; PairLJExpand::PairLJExpand(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_gromacs_coul_gromacs.cpp b/src/pair_lj_gromacs_coul_gromacs.cpp index e378b333e5..a5663ecfd8 100644 --- a/src/pair_lj_gromacs_coul_gromacs.cpp +++ b/src/pair_lj_gromacs_coul_gromacs.cpp @@ -34,7 +34,7 @@ using namespace LAMMPS_NS; PairLJGromacsCoulGromacs::PairLJGromacsCoulGromacs(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_smooth.cpp b/src/pair_lj_smooth.cpp index e6c39a8f92..bf97a44732 100644 --- a/src/pair_lj_smooth.cpp +++ b/src/pair_lj_smooth.cpp @@ -33,7 +33,7 @@ using namespace LAMMPS_NS; PairLJSmooth::PairLJSmooth(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_lj_smooth_linear.cpp b/src/pair_lj_smooth_linear.cpp index 4b3b43fbcb..19e84f971d 100644 --- a/src/pair_lj_smooth_linear.cpp +++ b/src/pair_lj_smooth_linear.cpp @@ -32,7 +32,7 @@ using namespace LAMMPS_NS; PairLJSmoothLinear::PairLJSmoothLinear(LAMMPS *lmp) : Pair(lmp) { single_hessian_enable = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_morse.cpp b/src/pair_morse.cpp index 9722780922..b883036c18 100644 --- a/src/pair_morse.cpp +++ b/src/pair_morse.cpp @@ -30,7 +30,7 @@ using namespace LAMMPS_NS; PairMorse::PairMorse(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ diff --git a/src/pair_ufm.cpp b/src/pair_ufm.cpp index 9fd2ebe880..dd5bd078a3 100644 --- a/src/pair_ufm.cpp +++ b/src/pair_ufm.cpp @@ -36,7 +36,7 @@ using namespace LAMMPS_NS; PairUFM::PairUFM(LAMMPS *lmp) : Pair(lmp) { writedata = 1; - cntratmstressflag = 1; + centroidstressflag = 1; } /* ---------------------------------------------------------------------- */ From b5c6647992c0301ed455ef2faf86607f6de8fdc3 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 18:42:34 +0900 Subject: [PATCH 388/557] prevent pair hybrid from needlessly allocating vatom when only cvatom is needed --- src/pair_hybrid.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/pair_hybrid.cpp b/src/pair_hybrid.cpp index 62c30cd2da..b6324f0d03 100644 --- a/src/pair_hybrid.cpp +++ b/src/pair_hybrid.cpp @@ -384,7 +384,7 @@ void PairHybrid::flags() if (styles[m]->dispersionflag) dispersionflag = 1; if (styles[m]->tip4pflag) tip4pflag = 1; if (styles[m]->compute_flag) compute_flag = 1; - centroidstressflag |= styles[m]->centroidstressflag; + if (styles[m]->centroidstressflag & 4) centroidstressflag |= 4; } init_svector(); } From b80e5d3d11eb1840fe98db66e0654efdb5297118 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 18:45:49 +0900 Subject: [PATCH 389/557] fix spelling: forth -> fourth --- doc/src/compute_stress_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst index 5ea34f68f6..e354d741e1 100644 --- a/doc/src/compute_stress_atom.rst +++ b/doc/src/compute_stress_atom.rst @@ -99,7 +99,7 @@ In case of compute *centroid/stress/atom*, the virial contribution is: W_{ab} & = \sum_{n = 1}^{N_p} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_b} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_a} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_d} r_{I0_a} F_{I_b} + \sum_{n = 1}^{N_i} r_{I0_a} F_{I_b} \\ & + {\rm Kspace}(r_{i_a},F_{i_b}) + \sum_{n = 1}^{N_f} r_{i_a} F_{i_b} -As with compute *stress/atom*, the first, second, third, forth and fifth terms +As with compute *stress/atom*, the first, second, third, fourth and fifth terms are pairwise, bond, angle, dihedral and improper contributions, but instead of assigning the virial contribution equally to each atom, only the force :math:`\mathbf{F}_I` acting on atom :math:`I` From e44c394680bdb7be16379e463e7db4aea0c4e89a Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 19:48:52 +0900 Subject: [PATCH 390/557] pairwise -> two-body for clarity in appropriate comments --- src/USER-OMP/thr_omp.cpp | 6 +++--- src/compute_centroid_stress_atom.cpp | 2 +- src/pair.h | 4 ++-- 3 files changed, 6 insertions(+), 6 deletions(-) diff --git a/src/USER-OMP/thr_omp.cpp b/src/USER-OMP/thr_omp.cpp index b6115ffe2a..c086f6d6b5 100644 --- a/src/USER-OMP/thr_omp.cpp +++ b/src/USER-OMP/thr_omp.cpp @@ -75,7 +75,7 @@ void ThrOMP::ev_setup_thr(int eflag, int vflag, int nall, double *eatom, if (nall > 0) memset(&(thr->eatom_pair[0]),0,nall*sizeof(double)); } - // per-atom virial and per-atom centroid virial are the same for pairwise + // per-atom virial and per-atom centroid virial are the same for two-body // many-body pair styles not yet implemented if (vflag & 12) { thr->vatom_pair = vatom + tid*nall; @@ -238,7 +238,7 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (eflag & 2) { data_reduce_thr(&(pair->eatom[0]), nall, nthreads, 1, tid); } - // per-atom virial and per-atom centroid virial are the same for pairwise + // per-atom virial and per-atom centroid virial are the same for two-body // many-body pair styles not yet implemented if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); @@ -389,7 +389,7 @@ void ThrOMP::reduce_thr(void *style, const int eflag, const int vflag, if (vflag & 8) { data_reduce_thr(&(dihedral->cvatom[0][0]), nall, nthreads, 9, tid); } - // per-atom virial and per-atom centroid virial are the same for pairwise + // per-atom virial and per-atom centroid virial are the same for two-body // many-body pair styles not yet implemented if (vflag & 12) { data_reduce_thr(&(pair->vatom[0][0]), nall, nthreads, 6, tid); diff --git a/src/compute_centroid_stress_atom.cpp b/src/compute_centroid_stress_atom.cpp index e623719841..3f5b2cba81 100644 --- a/src/compute_centroid_stress_atom.cpp +++ b/src/compute_centroid_stress_atom.cpp @@ -175,7 +175,7 @@ void ComputeCentroidStressAtom::compute_peratom() // add in per-atom contributions from each force - // per-atom virial and per-atom centroid virial are the same for pairwise + // per-atom virial and per-atom centroid virial are the same for two-body // many-body pair styles not yet implemented if (pairflag && force->pair) { if (force->pair->centroidstressflag & 2) { diff --git a/src/pair.h b/src/pair.h index aaab77d700..0aa48761ee 100644 --- a/src/pair.h +++ b/src/pair.h @@ -67,8 +67,8 @@ class Pair : protected Pointers { int reinitflag; // 1 if compatible with fix adapt and alike int centroidstressflag; // compatibility with centroid atomic stress - // 1 if same as pairwise atomic stress - // 2 if implemented and different from pairwise + // 1 if same as two-body atomic stress + // 2 if implemented and different from two-body // 4 if not compatible/implemented int tail_flag; // pair_modify flag for LJ tail correction From 85e96bf31c63637b61aa9d5c74812ae25ced8217 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 22:02:10 +0900 Subject: [PATCH 391/557] fix broken italization --- doc/src/compute_stress_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst index e354d741e1..142016d3c5 100644 --- a/doc/src/compute_stress_atom.rst +++ b/doc/src/compute_stress_atom.rst @@ -215,7 +215,7 @@ result. I.e. the last 2 columns of thermo output will be the same: This compute *stress/atom* calculates a per-atom array with 6 columns, which can be accessed by indices 1-6 by any command that uses per-atom values from a compute as input. -The compute "centroid/stress/atom* produces a per-atom array with 9 columns, +The compute *centroid/stress/atom* produces a per-atom array with 9 columns, but otherwise can be used in an identical manner to compute *stress/atom*. See the :doc:`Howto output ` doc page for an overview of LAMMPS output options. From 28269c4a2185e01bb1597f5aabba84730b4fc87a Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Wed, 13 Nov 2019 22:19:34 +0900 Subject: [PATCH 392/557] change wording to be more in line with LAMMPS terminology and current state of implementation --- doc/src/compute_heat_flux.rst | 9 ++++----- doc/src/compute_stress_atom.rst | 28 ++++++++++++++++++---------- 2 files changed, 22 insertions(+), 15 deletions(-) diff --git a/doc/src/compute_heat_flux.rst b/doc/src/compute_heat_flux.rst index df98c85b64..3b7058d3d3 100644 --- a/doc/src/compute_heat_flux.rst +++ b/doc/src/compute_heat_flux.rst @@ -54,7 +54,7 @@ third calculates per-atom stress (\ *stress-ID*\ ). (or any group whose atoms are superset of the atoms in this compute's group). LAMMPS does not check for this. -In case of pairwise interactions the heat flux is defined as: +In case of two-body interactions, the heat flux is defined as: .. math:: \mathbf{J} &= \frac{1}{V} \left[ \sum_i e_i \mathbf{v}_i - \sum_{i} \mathbf{S}_{i} \mathbf{v}_i \right] \\ @@ -69,10 +69,10 @@ per-atom stress tensor calculated by the compute *stress-ID*. See :doc:`compute stress/atom ` and :doc:`compute centroid/stress/atom ` for possible definitions of atomic stress :math:`\mathbf{S}_i` -in the case of thee-body and larger many-body interactions. +in the case of bonded and many-body interactions. The tensor multiplies :math:`\mathbf{v}_i` as a 3x3 matrix-vector multiply to yield a vector. -Note that as discussed below, the :math:`\frac{1}{V}` scaling factor in the +Note that as discussed below, the 1/:math:`{V}` scaling factor in the equation for :math:`\mathbf{J}` is NOT included in the calculation performed by these computes; you need to add it for a volume appropriate to the atoms included in the calculation. @@ -92,8 +92,7 @@ included in the calculation. .. warning:: The compute *heat/flux* has been reported to produce unphysical - values for three and larger many-body interactions such - as angles, dihedrals and torsions, + values for angle, dihedral and improper contributions when used with :doc:`compute stress/atom `, as discussed in :ref:`(Surblys) ` and :ref:`(Boone) `. You are strongly advised to diff --git a/doc/src/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst index 142016d3c5..412f5d9c5a 100644 --- a/doc/src/compute_stress_atom.rst +++ b/doc/src/compute_stress_atom.rst @@ -112,8 +112,7 @@ The sixth and seventh terms, Kspace and :doc:`fix ` contribution respectively, are computed identical to compute *stress/atom*. Although the total system virial is the same as compute *stress/atom*, compute *centroid/stress/atom* is know to result in more consistent -heat flux values for three and larger many-body interactions -such as angles, dihedrals and impropers, +heat flux values for angle, dihedras and improper contributions when computed via :doc:`compute heat/flux `. If no extra keywords are listed, the kinetic contribution @@ -138,16 +137,20 @@ the interaction, with the :math:`r` vectors unwrapped by periodic boundaries so that the cluster of atoms is close together. The total contribution for the cluster interaction is divided evenly among those atoms. Details of how compute *centroid/stress/atom* obtains -the virial for individual atoms for many-body potentials +the virial for individual atoms is given in :ref:`(Surblys) `, where the idea is that the virial of the atom :math:`I` is the result of only the force :math:`\mathbf{F}_I` on the atom due -to the many-body interaction +to the interaction and its positional vector :math:`\mathbf{r}_{I0}`, relative to the geometric center of the -interacting atoms. The periodic boundary treatment is identical to +interacting atoms, regardless of the number of participating atoms. +The periodic boundary treatment is identical to that of compute *stress/atom*, and both of them reduce to identical -expressions for pairwise interactions. +expressions for two-body interactions, +i.e. computed values for contributions from bonds and two-body pair styles, +such as :doc:`Lennard-Jones `, will be the same, +while contributions from angles, dihedrals and impropers will be different. The :doc:`dihedral\_style charmm ` style calculates pairwise interactions between 1-4 atoms. The virial contribution of @@ -225,10 +228,15 @@ The per-atom array values will be in pressure\*volume Restrictions """""""""""" -Pair styles with three and larger many-body interactions, -such as Tersoff do not currently support -compute *centroid/stress/atom* and LAMMPS will generate an error -in such cases. +Currently, compute *centroid/stress/atom* does not support +pair styles with many-body interactions, +such as :doc:`Tersoff `, +and LAMMPS will generate an error in such cases. +In principal, equivalent formulation +to that of angle, dihedral and improper contributions +in the virial :math:`W_{ab}` formula +can also be applied to the many-body pair styles, +and is planned in the future. Related commands """""""""""""""" From f18cb83defc85f860f0f03ae33f866250364e833 Mon Sep 17 00:00:00 2001 From: Donatas Surblys Date: Thu, 14 Nov 2019 01:07:30 +0900 Subject: [PATCH 393/557] fix spelling: dihedras -> dihedrals --- doc/src/compute_stress_atom.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/compute_stress_atom.rst b/doc/src/compute_stress_atom.rst index 412f5d9c5a..c37a8cc52d 100644 --- a/doc/src/compute_stress_atom.rst +++ b/doc/src/compute_stress_atom.rst @@ -112,7 +112,7 @@ The sixth and seventh terms, Kspace and :doc:`fix ` contribution respectively, are computed identical to compute *stress/atom*. Although the total system virial is the same as compute *stress/atom*, compute *centroid/stress/atom* is know to result in more consistent -heat flux values for angle, dihedras and improper contributions +heat flux values for angle, dihedrals and improper contributions when computed via :doc:`compute heat/flux `. If no extra keywords are listed, the kinetic contribution From 7e92c2e0eea51310222c2cc7f8966bf5d1ce3f02 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 13 Nov 2019 14:30:13 -0500 Subject: [PATCH 394/557] Add more detailed code documentation --- src/library.cpp | 88 +++++++++++++++++++++++++++++++++++-------------- src/library.h | 2 +- 2 files changed, 64 insertions(+), 26 deletions(-) diff --git a/src/library.cpp b/src/library.cpp index 407ec454a9..ee98e47aaa 100644 --- a/src/library.cpp +++ b/src/library.cpp @@ -1731,12 +1731,31 @@ int lammps_get_last_error_message(void *ptr, char * buffer, int buffer_size) { #endif -/* ---------------------------------------------------------------------- - Find neighbor list index for pair style -------------------------------------------------------------------------- */ -int lammps_find_pair_neighlist(void* ptr, char * style, int nsub, int request) { +/******************************************************************************* + * Find neighbor list index of pair style neighbor list + * + * Try finding pair instance that matches style. If exact is set, the pair must + * match style exactly. If exact is 0, style must only be contained. If pair is + * of style pair/hybrid, style is instead matched the nsub-th hybrid sub-style. + * + * Once the pair instance has been identified, multiple neighbor list requests + * may be found. Every neighbor list is uniquely identified by its request + * index. Thus, providing this request index ensures that the correct neighbor + * list index is returned. + * + * @param ptr Pointer to LAMMPS instance + * @param style String used to search for pair style instance + * @param exact Flag to control whether style should match exactly or only + * must be contained in pair style name + * @param nsub match nsub-th hybrid sub-style + * @param request request index that specifies which neighbor list should be + * returned, in case there are multiple neighbor lists requests + * for the found pair style + * @return return neighbor list index if found, otherwise -1 + ******************************************************************************/ +int lammps_find_pair_neighlist(void* ptr, char * style, int exact, int nsub, int request) { LAMMPS * lmp = (LAMMPS *) ptr; - Pair* pair = lmp->force->pair_match(style, 1, nsub); + Pair* pair = lmp->force->pair_match(style, exact, nsub); if (pair != NULL) { // find neigh list @@ -1752,11 +1771,15 @@ int lammps_find_pair_neighlist(void* ptr, char * style, int nsub, int request) { return -1; } -/* ---------------------------------------------------------------------- - Find neighbor list index for compute with given fix ID - The request ID identifies which request it is in case of there are - multiple neighbor lists for this fix -------------------------------------------------------------------------- */ +/******************************************************************************* + * Find neighbor list index of fix neighbor list + * + * @param ptr Pointer to LAMMPS instance + * @param id Identifier of fix instance + * @param request request index that specifies which request should be returned, + * in case there are multiple neighbor lists for this fix + * @return return neighbor list index if found, otherwise -1 + ******************************************************************************/ int lammps_find_fix_neighlist(void* ptr, char * id, int request) { LAMMPS * lmp = (LAMMPS *) ptr; Fix* fix = NULL; @@ -1784,12 +1807,15 @@ int lammps_find_fix_neighlist(void* ptr, char * id, int request) { return -1; } -/* ---------------------------------------------------------------------- - Find neighbor list index for compute with given compute ID - The request ID identifies which request it is in case of there are - multiple neighbor lists for this compute -------------------------------------------------------------------------- */ - +/******************************************************************************* + * Find neighbor list index of compute neighbor list + * + * @param ptr Pointer to LAMMPS instance + * @param id Identifier of fix instance + * @param request request index that specifies which request should be returned, + * in case there are multiple neighbor lists for this fix + * @return return neighbor list index if found, otherwise -1 + ******************************************************************************/ int lammps_find_compute_neighlist(void* ptr, char * id, int request) { LAMMPS * lmp = (LAMMPS *) ptr; Compute* compute = NULL; @@ -1817,10 +1843,14 @@ int lammps_find_compute_neighlist(void* ptr, char * id, int request) { return -1; } -/* ---------------------------------------------------------------------- - Return the number of entries in the neighbor list with given index -------------------------------------------------------------------------- */ - +/******************************************************************************* + * Return the number of entries in the neighbor list with given index + * + * @param ptr Pointer to LAMMPS instance + * @param idx neighbor list index + * @return return number of entries in neighbor list, -1 if idx is + * not a valid index + ******************************************************************************/ int lammps_neighlist_num_elements(void * ptr, int idx) { LAMMPS * lmp = (LAMMPS *) ptr; Neighbor * neighbor = lmp->neighbor; @@ -1833,11 +1863,19 @@ int lammps_neighlist_num_elements(void * ptr, int idx) { return list->inum; } -/* ---------------------------------------------------------------------- - Return atom index, number of neighbors and neighbor array for neighbor - list entry -------------------------------------------------------------------------- */ - +/******************************************************************************* + * Return atom local index, number of neighbors, and array of neighbor local + * atom indices of neighbor list entry + * + * @param ptr Pointer to LAMMPS instance + * @param idx neighbor list index + * @param element neighbor list element index + * @param[out] iatom atom local index in range [0, nlocal + nghost), -1 if + invalid idx or element index + * @param[out] numneigh number of neighbors of atom i or 0 + * @param[out] neighbors pointer to array of neighbor atom local indices or + * NULL + ******************************************************************************/ void lammps_neighlist_element_neighbors(void * ptr, int idx, int element, int * iatom, int * numneigh, int ** neighbors) { LAMMPS * lmp = (LAMMPS *) ptr; Neighbor * neighbor = lmp->neighbor; diff --git a/src/library.h b/src/library.h index 3d67a46974..ce5e983f2f 100644 --- a/src/library.h +++ b/src/library.h @@ -78,7 +78,7 @@ int lammps_config_has_jpeg_support(); int lammps_config_has_ffmpeg_support(); int lammps_config_has_exceptions(); -int lammps_find_pair_neighlist(void* ptr, char * style, int nsub, int request); +int lammps_find_pair_neighlist(void* ptr, char * style, int exact, int nsub, int request); int lammps_find_fix_neighlist(void* ptr, char * id, int request); int lammps_find_compute_neighlist(void* ptr, char * id, int request); int lammps_neighlist_num_elements(void* ptr, int idx); From 28a9dc40cbf615b03f90e9cb3d629c779599a739 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 13 Nov 2019 15:53:25 -0500 Subject: [PATCH 395/557] Add docstring to new lammps.py methods --- python/lammps.py | 92 +++++++++++++++++++++++++++++++++++++++++++++--- 1 file changed, 88 insertions(+), 4 deletions(-) diff --git a/python/lammps.py b/python/lammps.py index 665c8b43b8..e8fc240c75 100644 --- a/python/lammps.py +++ b/python/lammps.py @@ -52,6 +52,17 @@ class MPIAbortException(Exception): return repr(self.message) class NeighList: + """This is a wrapper class that exposes the contents of a neighbor list + + It can be used like a regular Python list. + + Internally it uses the lower-level LAMMPS C-library interface. + + :param lmp: reference to instance of :class:`lammps` + :type lmp: lammps + :param idx: neighbor list index + :type idx: int + """ def __init__(self, lmp, idx): self.lmp = lmp self.idx = idx @@ -64,15 +75,24 @@ class NeighList: @property def size(self): + """ + :return: number of elements in neighbor list + """ return self.lmp.get_neighlist_size(self.idx) def get(self, element): + """ + :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices + :rtype: (int, int, numpy.array) + """ iatom, numneigh, neighbors = self.lmp.get_neighlist_element_neighbors(self.idx, element) return iatom, numneigh, neighbors + # the methods below implement the iterator interface, so NeighList can be used like a regular Python list + def __getitem__(self, element): return self.get(element) - + def __len__(self): return self.size @@ -169,7 +189,7 @@ class lammps(object): [c_void_p,c_char_p,c_int,c_int,c_int,POINTER(c_int),c_void_p] self.lib.lammps_scatter_atoms_subset.restype = None - self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int] + self.lib.lammps_find_pair_neighlist.argtypes = [c_void_p, c_char_p, c_int, c_int, c_int] self.lib.lammps_find_pair_neighlist.restype = c_int self.lib.lammps_find_fix_neighlist.argtypes = [c_void_p, c_char_p, c_int] @@ -699,29 +719,93 @@ class lammps(object): self.lib.lammps_set_fix_external_callback(self.lmp, fix_name.encode(), cFunc, cCaller) def get_neighlist(self, idx): + """Returns an instance of :class:`NeighList` which wraps access to the neighbor list with the given index + + :param idx: index of neighbor list + :type idx: int + :return: an instance of :class:`NeighList` wrapping access to neighbor list data + :rtype: NeighList + """ if idx < 0: return None return NeighList(self, idx) - def find_pair_neighlist(self, style, nsub=0, request=0): + def find_pair_neighlist(self, style, exact=True, nsub=0, request=0): + """Find neighbor list index of pair style neighbor list + + Try finding pair instance that matches style. If exact is set, the pair must + match style exactly. If exact is 0, style must only be contained. If pair is + of style pair/hybrid, style is instead matched the nsub-th hybrid sub-style. + + Once the pair instance has been identified, multiple neighbor list requests + may be found. Every neighbor list is uniquely identified by its request + index. Thus, providing this request index ensures that the correct neighbor + list index is returned. + + :param style: name of pair style that should be searched for + :type style: string + :param exact: controls whether style should match exactly or only must be contained in pair style name, defaults to True + :type exact: bool, optional + :param nsub: match nsub-th hybrid sub-style, defaults to 0 + :type nsub: int, optional + :param request: index of neighbor list request, in case there are more than one, defaults to 0 + :type request: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + """ style = style.encode() - idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, nsub, request) + exact = int(exact) + idx = self.lib.lammps_find_pair_neighlist(self.lmp, style, exact, nsub, request) return self.get_neighlist(idx) def find_fix_neighlist(self, fixid, request=0): + """Find neighbor list index of fix neighbor list + + :param fixid: name of fix + :type fixid: string + :param request: index of neighbor list request, in case there are more than one, defaults to 0 + :type request: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + """ fixid = fixid.encode() idx = self.lib.lammps_find_fix_neighlist(self.lmp, fixid, request) return self.get_neighlist(idx) def find_compute_neighlist(self, computeid, request=0): + """Find neighbor list index of compute neighbor list + + :param computeid: name of compute + :type computeid: string + :param request: index of neighbor list request, in case there are more than one, defaults to 0 + :type request: int, optional + :return: neighbor list index if found, otherwise -1 + :rtype: int + """ computeid = computeid.encode() idx = self.lib.lammps_find_compute_neighlist(self.lmp, computeid, request) return self.get_neighlist(idx) def get_neighlist_size(self, idx): + """Return the number of elements in neighbor list with the given index + + :param idx: neighbor list index + :type idx: int + :return: number of elements in neighbor list with index idx + :rtype: int + """ return self.lib.lammps_neighlist_num_elements(self.lmp, idx) def get_neighlist_element_neighbors(self, idx, element): + """Return data of neighbor list entry + + :param element: neighbor list index + :type element: int + :param element: neighbor list element index + :type element: int + :return: tuple with atom local index, number of neighbors and array of neighbor local atom indices + :rtype: (int, int, numpy.array) + """ c_iatom = c_int() c_numneigh = c_int() c_neighbors = POINTER(c_int)() From 62b3e790220d751dca64ff82c0fabb89adb7d3a0 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Wed, 13 Nov 2019 15:54:22 -0500 Subject: [PATCH 396/557] Add autodoc for lammps.lammps and lammps.NeighList --- doc/src/Python_library.rst | 21 ++- doc/txt/Python_library.txt | 256 -------------------------------- doc/utils/sphinx-config/conf.py | 6 +- 3 files changed, 20 insertions(+), 263 deletions(-) delete mode 100644 doc/txt/Python_library.txt diff --git a/doc/src/Python_library.rst b/doc/src/Python_library.rst index 8ad01e8a2b..e079df1a04 100644 --- a/doc/src/Python_library.rst +++ b/doc/src/Python_library.rst @@ -9,7 +9,7 @@ below assumes you have first imported the "lammps" module in your Python script, as follows: -.. parsed-literal:: +.. code-block:: Python from lammps import lammps @@ -23,7 +23,7 @@ The python/examples directory has Python scripts which show how Python can run LAMMPS, grab data, change it, and put it back into LAMMPS. -.. parsed-literal:: +.. code-block:: Python lmp = lammps() # create a LAMMPS object using the default liblammps.so library # 4 optional args are allowed: name, cmdargs, ptr, comm @@ -100,7 +100,7 @@ can run LAMMPS, grab data, change it, and put it back into LAMMPS. The lines -.. parsed-literal:: +.. code-block:: Python from lammps import lammps lmp = lammps() @@ -117,7 +117,7 @@ prompt. If the ptr argument is set like this: -.. parsed-literal:: +.. code-block:: Python lmp = lammps(ptr=lmpptr) @@ -134,7 +134,7 @@ Note that you can create multiple LAMMPS objects in your Python script, and coordinate and run multiple simulations, e.g. -.. parsed-literal:: +.. code-block:: Python from lammps import lammps lmp1 = lammps() @@ -230,7 +230,7 @@ ctypes vector of ints or doubles, allocated and initialized something like this: -.. parsed-literal:: +.. code-block:: Python from ctypes import \* natoms = lmp.get_natoms() @@ -265,6 +265,15 @@ following steps: Python script. +---------- + +.. autoclass:: lammps.lammps + :members: + :no-undoc-members: + +.. autoclass:: lammps.NeighList + :members: + :no-undoc-members: .. _lws: http://lammps.sandia.gov .. _ld: Manual.html diff --git a/doc/txt/Python_library.txt b/doc/txt/Python_library.txt deleted file mode 100644 index d9ddbe0cbb..0000000000 --- a/doc/txt/Python_library.txt +++ /dev/null @@ -1,256 +0,0 @@ -"Higher level section"_Python_head.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 - -Python library interface :h3 - -As described previously, the Python interface to LAMMPS consists of a -Python "lammps" module, the source code for which is in -python/lammps.py, which creates a "lammps" object, with a set of -methods that can be invoked on that object. The sample Python code -below assumes you have first imported the "lammps" module in your -Python script, as follows: - -from lammps import lammps :pre - -These are the methods defined by the lammps module. If you look at -the files src/library.cpp and src/library.h you will see they -correspond one-to-one with calls you can make to the LAMMPS library -from a C++ or C or Fortran program, and which are described on the -"Howto library"_Howto_library.html doc page. - -The python/examples directory has Python scripts which show how Python -can run LAMMPS, grab data, change it, and put it back into LAMMPS. - -lmp = lammps() # create a LAMMPS object using the default liblammps.so library - # 4 optional args are allowed: name, cmdargs, ptr, comm -lmp = lammps(ptr=lmpptr) # use lmpptr as previously created LAMMPS object -lmp = lammps(comm=split) # create a LAMMPS object with a custom communicator, requires mpi4py 2.0.0 or later -lmp = lammps(name="g++") # create a LAMMPS object using the liblammps_g++.so library -lmp = lammps(name="g++",cmdargs=list) # add LAMMPS command-line args, e.g. list = \["-echo","screen"\] :pre - -lmp.close() # destroy a LAMMPS object :pre - -version = lmp.version() # return the numerical version id, e.g. LAMMPS 2 Sep 2015 -> 20150902 :pre - -lmp.file(file) # run an entire input script, file = "in.lj" -lmp.command(cmd) # invoke a single LAMMPS command, cmd = "run 100" -lmp.commands_list(cmdlist) # invoke commands in cmdlist = ["run 10", "run 20"] -lmp.commands_string(multicmd) # invoke commands in multicmd = "run 10\nrun 20" :pre - -size = lmp.extract_setting(name) # return data type info :pre - -xlo = lmp.extract_global(name,type) # extract a global quantity - # name = "boxxlo", "nlocal", etc - # type = 0 = int - # 1 = double :pre - -boxlo,boxhi,xy,yz,xz,periodicity,box_change = lmp.extract_box() # extract box info :pre - -coords = lmp.extract_atom(name,type) # extract a per-atom quantity - # name = "x", "type", etc - # type = 0 = vector of ints - # 1 = array of ints - # 2 = vector of doubles - # 3 = array of doubles :pre - -eng = lmp.extract_compute(id,style,type) # extract value(s) from a compute -v3 = lmp.extract_fix(id,style,type,i,j) # extract value(s) from a fix - # id = ID of compute or fix - # style = 0 = global data - # 1 = per-atom data - # 2 = local data - # type = 0 = scalar - # 1 = vector - # 2 = array - # i,j = indices of value in global vector or array :pre - -var = lmp.extract_variable(name,group,flag) # extract value(s) from a variable - # name = name of variable - # group = group ID (ignored for equal-style variables) - # flag = 0 = equal-style variable - # 1 = atom-style variable :pre - -value = lmp.get_thermo(name) # return current value of a thermo keyword -natoms = lmp.get_natoms() # total # of atoms as int :pre - -flag = lmp.set_variable(name,value) # set existing named string-style variable to value, flag = 0 if successful -lmp.reset_box(boxlo,boxhi,xy,yz,xz) # reset the simulation box size :pre - -data = lmp.gather_atoms(name,type,count) # return per-atom property of all atoms gathered into data, ordered by atom ID - # name = "x", "charge", "type", etc -data = lmp.gather_atoms_concat(name,type,count) # ditto, but concatenated atom values from each proc (unordered) -data = lmp.gather_atoms_subset(name,type,count,ndata,ids) # ditto, but for subset of Ndata atoms with IDs :pre - -lmp.scatter_atoms(name,type,count,data) # scatter per-atom property to all atoms from data, ordered by atom ID - # name = "x", "charge", "type", etc - # count = # of per-atom values, 1 or 3, etc :pre -lmp.scatter_atoms_subset(name,type,count,ndata,ids,data) # ditto, but for subset of Ndata atoms with IDs :pre - -lmp.create_atoms(n,ids,types,x,v,image,shrinkexceed) # create N atoms with IDs, types, x, v, and image flags :pre - -:line - -The lines - -from lammps import lammps -lmp = lammps() :pre - -create an instance of LAMMPS, wrapped in a Python class by the lammps -Python module, and return an instance of the Python class as lmp. It -is used to make all subsequent calls to the LAMMPS library. - -Additional arguments to lammps() can be used to tell Python the name -of the shared library to load or to pass arguments to the LAMMPS -instance, the same as if LAMMPS were launched from a command-line -prompt. - -If the ptr argument is set like this: - -lmp = lammps(ptr=lmpptr) :pre - -then lmpptr must be an argument passed to Python via the LAMMPS -"python"_python.html command, when it is used to define a Python -function that is invoked by the LAMMPS input script. This mode of -calling Python from LAMMPS is described in the "Python -call"_Python_call.html doc page. The variable lmpptr refers to the -instance of LAMMPS that called the embedded Python interpreter. Using -it as an argument to lammps() allows the returned Python class -instance "lmp" to make calls to that instance of LAMMPS. See the -"python"_python.html command doc page for examples using this syntax. - -Note that you can create multiple LAMMPS objects in your Python -script, and coordinate and run multiple simulations, e.g. - -from lammps import lammps -lmp1 = lammps() -lmp2 = lammps() -lmp1.file("in.file1") -lmp2.file("in.file2") :pre - -The file(), command(), commands_list(), commands_string() methods -allow an input script, a single command, or multiple commands to be -invoked. - -The extract_setting(), extract_global(), extract_box(), -extract_atom(), extract_compute(), extract_fix(), and -extract_variable() methods return values or pointers to data -structures internal to LAMMPS. - -For extract_global() see the src/library.cpp file for the list of -valid names. New names could easily be added. A double or integer is -returned. You need to specify the appropriate data type via the type -argument. - -For extract_atom(), a pointer to internal LAMMPS atom-based data is -returned, which you can use via normal Python subscripting. See the -extract() method in the src/atom.cpp file for a list of valid names. -Again, new names could easily be added if the property you want is not -listed. A pointer to a vector of doubles or integers, or a pointer to -an array of doubles (double **) or integers (int **) is returned. You -need to specify the appropriate data type via the type argument. - -For extract_compute() and extract_fix(), the global, per-atom, or -local data calculated by the compute or fix can be accessed. What is -returned depends on whether the compute or fix calculates a scalar or -vector or array. For a scalar, a single double value is returned. If -the compute or fix calculates a vector or array, a pointer to the -internal LAMMPS data is returned, which you can use via normal Python -subscripting. The one exception is that for a fix that calculates a -global vector or array, a single double value from the vector or array -is returned, indexed by I (vector) or I and J (array). I,J are -zero-based indices. The I,J arguments can be left out if not needed. -See the "Howto output"_Howto_output.html doc page for a discussion of -global, per-atom, and local data, and of scalar, vector, and array -data types. See the doc pages for individual "computes"_compute.html -and "fixes"_fix.html for a description of what they calculate and -store. - -For extract_variable(), an "equal-style or atom-style -variable"_variable.html is evaluated and its result returned. - -For equal-style variables a single double value is returned and the -group argument is ignored. For atom-style variables, a vector of -doubles is returned, one value per atom, which you can use via normal -Python subscripting. The values will be zero for atoms not in the -specified group. - -The get_thermo() method returns the current value of a thermo -keyword as a float. - -The get_natoms() method returns the total number of atoms in the -simulation, as an int. - -The set_variable() method sets an existing string-style variable to a -new string value, so that subsequent LAMMPS commands can access the -variable. - -The reset_box() method resets the size and shape of the simulation -box, e.g. as part of restoring a previously extracted and saved state -of a simulation. - -The gather methods collect peratom info of the requested type (atom -coords, atom types, forces, etc) from all processors, and returns the -same vector of values to each calling processor. The scatter -functions do the inverse. They distribute a vector of peratom values, -passed by all calling processors, to individual atoms, which may be -owned by different processors. - -Note that the data returned by the gather methods, -e.g. gather_atoms("x"), is different from the data structure returned -by extract_atom("x") in four ways. (1) Gather_atoms() returns a -vector which you index as x\[i\]; extract_atom() returns an array -which you index as x\[i\]\[j\]. (2) Gather_atoms() orders the atoms -by atom ID while extract_atom() does not. (3) Gather_atoms() returns -a list of all atoms in the simulation; extract_atoms() returns just -the atoms local to each processor. (4) Finally, the gather_atoms() -data structure is a copy of the atom coords stored internally in -LAMMPS, whereas extract_atom() returns an array that effectively -points directly to the internal data. This means you can change -values inside LAMMPS from Python by assigning a new values to the -extract_atom() array. To do this with the gather_atoms() vector, you -need to change values in the vector, then invoke the scatter_atoms() -method. - -For the scatter methods, the array of coordinates passed to must be a -ctypes vector of ints or doubles, allocated and initialized something -like this: - -from ctypes import * -natoms = lmp.get_natoms() -n3 = 3*natoms -x = (n3*c_double)() -x\[0\] = x coord of atom with ID 1 -x\[1\] = y coord of atom with ID 1 -x\[2\] = z coord of atom with ID 1 -x\[3\] = x coord of atom with ID 2 -... -x\[n3-1\] = z coord of atom with ID natoms -lmp.scatter_atoms("x",1,3,x) :pre - -Alternatively, you can just change values in the vector returned by -the gather methods, since they are also ctypes vectors. - -:line - -As noted above, these Python class methods correspond one-to-one with -the functions in the LAMMPS library interface in src/library.cpp and -library.h. This means you can extend the Python wrapper via the -following steps: - -Add a new interface function to src/library.cpp and -src/library.h. :ulb,l - -Rebuild LAMMPS as a shared library. :l - -Add a wrapper method to python/lammps.py for this interface -function. :l - -You should now be able to invoke the new interface function from a -Python script. :l -:ule diff --git a/doc/utils/sphinx-config/conf.py b/doc/utils/sphinx-config/conf.py index 70a96e1614..a002f5cdcb 100644 --- a/doc/utils/sphinx-config/conf.py +++ b/doc/utils/sphinx-config/conf.py @@ -30,7 +30,9 @@ import os # extensions coming with Sphinx (named 'sphinx.ext.*') or your custom # ones. extensions = [ - 'sphinx.ext.mathjax', 'sphinx.ext.imgmath' + 'sphinx.ext.mathjax', + 'sphinx.ext.imgmath', + 'sphinx.ext.autodoc', ] # 2017-12-07: commented out, since this package is broken with Sphinx 16.x # yet we can no longer use Sphinx 15.x, since that breaks with @@ -323,3 +325,5 @@ import LAMMPSLexer from sphinx.highlighting import lexers lexers['LAMMPS'] = LAMMPSLexer.LAMMPSLexer(startinline=True) + +sys.path.append(os.path.join(os.path.dirname(__file__), '../../../python')) From 93bd2f4ab0cf50fd8dd25c6c4b645ab7ce19fb15 Mon Sep 17 00:00:00 2001 From: julient31 Date: Wed, 13 Nov 2019 20:46:28 -0700 Subject: [PATCH 397/557] Commit JT 111319 - addind 4 first benchmark examples (in examples/SPIN/benchmark) - corrected typo in examples (in dump commands) --- .../bench-spin-precession.in | 39 + .../llg_exchange.py | 72 + .../plot_precession.py | 44 + .../benchmarck_damped_exchange/res_lammps.dat | 3001 ++ .../benchmarck_damped_exchange/res_llg.dat | 30000 ++++++++++++++++ .../run-bench-exchange.sh | 19 + .../benchmarck_damped_exchange/two_spins.data | 22 + .../bench-spin-precession.in | 48 + .../llg_precession.py | 51 + .../plot_precession.py | 39 + .../run-bench-prec.sh | 19 + .../bench-exchange-spin.template | 41 + .../langevin-exchange.py | 34 + .../plot_exchange.py | 34 + .../run-bench-exchange.sh | 28 + .../bench-prec-spin.template | 46 + .../langevin.py | 27 + .../plot_precession.py | 37 + .../run-bench-prec.sh | 27 + examples/SPIN/bfo/in.spin.bfo | 2 +- examples/SPIN/cobalt_fcc/in.spin.cobalt_fcc | 4 +- examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp | 3 +- examples/SPIN/iron/in.spin.iron | 3 +- examples/SPIN/iron/in.spin.iron_cubic | 2 +- examples/SPIN/nickel/in.spin.nickel | 2 +- src/SPIN/fix_langevin_spin.cpp | 3 +- src/SPIN/pair_spin_exchange.cpp | 14 +- 27 files changed, 33646 insertions(+), 15 deletions(-) create mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in create mode 100755 examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py create mode 100755 examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py create mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat create mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat create mode 100755 examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh create mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data create mode 100644 examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in create mode 100755 examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py create mode 100755 examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py create mode 100755 examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh create mode 100644 examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh create mode 100644 examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py create mode 100755 examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in b/examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in new file mode 100644 index 0000000000..0ca49364d2 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in @@ -0,0 +1,39 @@ +#LAMMPS in.run + +units metal +atom_style spin +atom_modify map array +boundary f f f + +read_data two_spins.data + +pair_style spin/exchange 3.1 +pair_coeff * * exchange 3.1 11.254 0.0 1.0 + +group bead type 1 + +variable H equal 0.0 +variable Kan equal 0.0 +variable Temperature equal 0.0 +variable RUN equal 30000 + +fix 1 all nve/spin lattice no +fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 +fix_modify 2 energy yes +fix 3 all langevin/spin ${Temperature} 0.01 12345 + +compute out_mag all spin +compute out_pe all pe + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] + +thermo_style custom step time v_magx v_magy v_magz v_emag pe etotal +thermo 10 + +timestep 0.0001 + +run ${RUN} diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py b/examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py new file mode 100755 index 0000000000..a8639925f6 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py @@ -0,0 +1,72 @@ +#!/usr/bin/env python3 + +import numpy as np , pylab, tkinter +import math +import matplotlib.pyplot as plt +import mpmath as mp + +hbar=0.658212 # Planck's constant (eV.fs/rad) +J0=0.05 # per-neighbor exchange interaction (eV) +S1 = np.array([1.0, 0.0, 0.0]) +S2 = np.array([0.0, 1.0, 0.0]) +alpha=0.01 # damping coefficient +pi=math.pi + +N=30000 # number of timesteps +dt=0.1 # timestep (fs) + +# Rodrigues rotation formula +def rotation_matrix(axis, theta): + """ + Return the rotation matrix associated with counterclockwise + rotation about the given axis by theta radians + """ + axis = np.asarray(axis) + a = math.cos(theta / 2.0) + b, c, d = -axis * math.sin(theta / 2.0) + aa, bb, cc, dd = a * a, b * b, c * c, d * d + bc, ad, ac, ab, bd, cd = b * c, a * d, a * c, a * b, b * d, c * d + return np.array([[aa + bb - cc - dd, 2 * (bc + ad), 2 * (bd - ac)], + [2 * (bc - ad), aa + cc - bb - dd, 2 * (cd + ab)], + [2 * (bd + ac), 2 * (cd - ab), aa + dd - bb - cc]]) + +# calculating precession field of spin Sr +def calc_rot_vector(Sr,Sf): + rot = (J0/hbar)*(Sf-alpha*np.cross(Sf,Sr))/(1.0+alpha**2) + return rot + +# second-order ST decomposition as implemented in LAMMPS +for t in range (0,N): + # advance s1 by dt/4 + wf1 = calc_rot_vector(S1,S2) + theta=dt*np.linalg.norm(wf1)*0.25 + axis=wf1/np.linalg.norm(wf1) + S1 = np.dot(rotation_matrix(axis, theta), S1) + # advance s2 by dt/2 + wf2 = calc_rot_vector(S2,S1) + theta=dt*np.linalg.norm(wf2)*0.5 + axis=wf2/np.linalg.norm(wf2) + S2 = np.dot(rotation_matrix(axis, theta), S2) + # advance s1 by dt/2 + wf1 = calc_rot_vector(S1,S2) + theta=dt*np.linalg.norm(wf1)*0.5 + axis=wf1/np.linalg.norm(wf1) + S1 = np.dot(rotation_matrix(axis, theta), S1) + # advance s2 by dt/2 + wf2 = calc_rot_vector(S2,S1) + theta=dt*np.linalg.norm(wf2)*0.5 + axis=wf2/np.linalg.norm(wf2) + S2 = np.dot(rotation_matrix(axis, theta), S2) + # advance s1 by dt/4 + wf1 = calc_rot_vector(S1,S2) + theta=dt*np.linalg.norm(wf1)*0.25 + axis=wf1/np.linalg.norm(wf1) + S1 = np.dot(rotation_matrix(axis, theta), S1) + # calc. average magnetization + Sm = (S1+S2)*0.5 + # calc. energy + # en = -hbar*(np.dot(S1,wf1)+np.dot(S2,wf2)) + en = -2.0*J0*(np.dot(S1,S2)) + # print res. in ps for comparison with LAMMPS + print(t*dt/1000.0,Sm[0],Sm[1],Sm[2],en) + # print(t*dt/1000.0,S1[0],S2[0],S1[1],S2[1],S1[2],S2[2],en) diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py b/examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py new file mode 100755 index 0000000000..6c8afca569 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py @@ -0,0 +1,44 @@ +#!/usr/bin/env python3 + +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +from scipy.optimize import curve_fit +from decimal import * +import sys, string, os + + +argv = sys.argv +if len(argv) != 3: + print("Syntax: ./plot_precession.py res_lammps.dat res_llg.dat") + sys.exit() + +lammps_file = sys.argv[1] +llg_file = sys.argv[2] + +t_lmp,Sx_lmp,Sy_lmp,Sz_lmp,e_lmp = np.loadtxt(lammps_file,skiprows=0, usecols=(1,2,3,4,5),unpack=True) +t_llg,Sx_llg,Sy_llg,Sz_llg,e_llg = np.loadtxt(llg_file,skiprows=0, usecols=(0,1,2,3,4),unpack=True) + +plt.figure() +plt.subplot(411) +plt.ylabel('Sx') +plt.plot(t_lmp, Sx_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sx_llg, 'r--', label='LLG') + +plt.subplot(412) +plt.ylabel('Sy') +plt.plot(t_lmp, Sy_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sy_llg, 'r--', label='LLG') + +plt.subplot(413) +plt.ylabel('Sz') +plt.plot(t_lmp, Sz_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sz_llg, 'r--', label='LLG') + +plt.subplot(414) +plt.ylabel('E (eV)') +plt.plot(t_lmp, e_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, e_llg, 'r--', label='LLG') + +plt.xlabel('time (in ps)') +plt.legend() +plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat new file mode 100644 index 0000000000..aa331f50ea --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat @@ -0,0 +1,3001 @@ + 0 0 0.5 0.5 0 0 0 0 + 10 0.001 0.50037967 0.50037966 6.8386474e-08 -0.00015191886 -0.00015191886 -0.00015191886 + 20 0.002 0.50075905 0.50075902 1.3603286e-07 -0.00030383701 -0.00030383701 -0.00030383701 + 30 0.003 0.50113814 0.50113809 2.0215189e-07 -0.00045575377 -0.00045575377 -0.00045575377 + 40 0.004 0.50151695 0.50151686 2.6596985e-07 -0.00060766842 -0.00060766842 -0.00060766842 + 50 0.005 0.50189547 0.50189534 3.2673578e-07 -0.00075958028 -0.00075958028 -0.00075958028 + 60 0.006 0.5022737 0.50227351 3.8373034e-07 -0.00091148862 -0.00091148862 -0.00091148862 + 70 0.007 0.50265165 0.50265139 4.3627448e-07 -0.0010633928 -0.0010633928 -0.0010633928 + 80 0.008 0.50302929 0.50302897 4.8373764e-07 -0.001215292 -0.001215292 -0.001215292 + 90 0.009 0.50340665 0.50340624 5.2554551e-07 -0.0013671856 -0.0013671856 -0.0013671856 + 100 0.01 0.50378371 0.50378322 5.6118711e-07 -0.001519073 -0.001519073 -0.001519073 + 110 0.011 0.50416047 0.50415989 5.9022131e-07 -0.0016709533 -0.0016709533 -0.0016709533 + 120 0.012 0.50453694 0.50453626 6.1228239e-07 -0.0018228259 -0.0018228259 -0.0018228259 + 130 0.013 0.5049131 0.50491233 6.2708498e-07 -0.0019746901 -0.0019746901 -0.0019746901 + 140 0.014 0.50528896 0.50528809 6.3442788e-07 -0.0021265452 -0.0021265452 -0.0021265452 + 150 0.015 0.50566452 0.50566355 6.3419702e-07 -0.0022783904 -0.0022783904 -0.0022783904 + 160 0.016 0.50603978 0.50603871 6.2636743e-07 -0.0024302252 -0.0024302252 -0.0024302252 + 170 0.017 0.50641473 0.50641356 6.1100409e-07 -0.0025820488 -0.0025820488 -0.0025820488 + 180 0.018 0.50678937 0.50678811 5.8826175e-07 -0.0027338604 -0.0027338604 -0.0027338604 + 190 0.019 0.5071637 0.50716235 5.5838372e-07 -0.0028856595 -0.0028856595 -0.0028856595 + 200 0.02 0.50753772 0.50753628 5.2169947e-07 -0.0030374452 -0.0030374452 -0.0030374452 + 210 0.021 0.50791142 0.50790991 4.7862136e-07 -0.0031892169 -0.0031892169 -0.0031892169 + 220 0.022 0.50828482 0.50828322 4.2964016e-07 -0.0033409739 -0.0033409739 -0.0033409739 + 230 0.023 0.50865789 0.50865624 3.7531975e-07 -0.0034927156 -0.0034927156 -0.0034927156 + 240 0.024 0.50903065 0.50902894 3.1629077e-07 -0.0036444411 -0.0036444411 -0.0036444411 + 250 0.025 0.50940309 0.50940133 2.5324353e-07 -0.0037961498 -0.0037961498 -0.0037961498 + 260 0.026 0.50977521 0.50977342 1.8692008e-07 -0.003947841 -0.003947841 -0.003947841 + 270 0.027 0.51014701 0.51014519 1.1810555e-07 -0.0040995141 -0.0040995141 -0.0040995141 + 280 0.028 0.51051849 0.51051665 4.7619044e-08 -0.0042511682 -0.0042511682 -0.0042511682 + 290 0.029 0.51088964 0.5108878 -2.3696119e-08 -0.0044028027 -0.0044028027 -0.0044028027 + 300 0.03 0.51126047 0.51125863 -9.4982408e-08 -0.004554417 -0.004554417 -0.004554417 + 310 0.031 0.51163097 0.51162915 -1.653784e-07 -0.0047060103 -0.0047060103 -0.0047060103 + 320 0.032 0.51200115 0.51199936 -2.3402922e-07 -0.0048575819 -0.0048575819 -0.0048575819 + 330 0.033 0.512371 0.51236925 -3.0009692e-07 -0.0050091312 -0.0050091312 -0.0050091312 + 340 0.034 0.51274052 0.51273882 -3.6277088e-07 -0.0051606574 -0.0051606574 -0.0051606574 + 350 0.035 0.51310971 0.51310807 -4.2127775e-07 -0.0053121598 -0.0053121598 -0.0053121598 + 360 0.036 0.51347857 0.513477 -4.7489123e-07 -0.0054636378 -0.0054636378 -0.0054636378 + 370 0.037 0.51384711 0.51384561 -5.2294115e-07 -0.0056150906 -0.0056150906 -0.0056150906 + 380 0.038 0.51421531 0.51421389 -5.6482212e-07 -0.0057665177 -0.0057665177 -0.0057665177 + 390 0.039 0.51458318 0.51458185 -6.0000127e-07 -0.0059179181 -0.0059179181 -0.0059179181 + 400 0.04 0.51495072 0.51494949 -6.2802531e-07 -0.0060692914 -0.0060692914 -0.0060692914 + 410 0.041 0.51531793 0.51531679 -6.4852657e-07 -0.0062206367 -0.0062206367 -0.0062206367 + 420 0.042 0.51568481 0.51568377 -6.6122807e-07 -0.0063719535 -0.0063719535 -0.0063719535 + 430 0.043 0.51605135 0.51605041 -6.659475e-07 -0.0065232409 -0.0065232409 -0.0065232409 + 440 0.044 0.51641756 0.51641673 -6.6260004e-07 -0.0066744984 -0.0066744984 -0.0066744984 + 450 0.045 0.51678344 0.51678271 -6.5120005e-07 -0.0068257252 -0.0068257252 -0.0068257252 + 460 0.046 0.51714898 0.51714835 -6.3186146e-07 -0.0069769206 -0.0069769206 -0.0069769206 + 470 0.047 0.51751419 0.51751365 -6.0479702e-07 -0.007128084 -0.007128084 -0.007128084 + 480 0.048 0.51787906 0.51787862 -5.7031623e-07 -0.0072792147 -0.0072792147 -0.0072792147 + 490 0.049 0.51824361 0.51824324 -5.2882208e-07 -0.0074303119 -0.0074303119 -0.0074303119 + 500 0.05 0.51860781 0.51860753 -4.8080667e-07 -0.0075813751 -0.0075813751 -0.0075813751 + 510 0.051 0.51897168 0.51897147 -4.2684553e-07 -0.0077324034 -0.0077324034 -0.0077324034 + 520 0.052 0.51933522 0.51933506 -3.6759103e-07 -0.0078833963 -0.0078833963 -0.0078833963 + 530 0.053 0.51969841 0.51969831 -3.0376461e-07 -0.008034353 -0.008034353 -0.008034353 + 540 0.054 0.52006127 0.52006121 -2.3614824e-07 -0.0081852728 -0.0081852728 -0.0081852728 + 550 0.055 0.5204238 0.52042377 -1.6557495e-07 -0.0083361551 -0.0083361551 -0.0083361551 + 560 0.056 0.52078598 0.52078597 -9.2918676e-08 -0.0084869992 -0.0084869992 -0.0084869992 + 570 0.057 0.52114783 0.52114782 -1.9083552e-08 -0.0086378045 -0.0086378045 -0.0086378045 + 580 0.058 0.52150933 0.52150932 5.5007325e-08 -0.0087885701 -0.0087885701 -0.0087885701 + 590 0.059 0.5218705 0.52187047 1.2842339e-07 -0.0089392955 -0.0089392955 -0.0089392955 + 600 0.06 0.52223132 0.52223127 2.0023832e-07 -0.00908998 -0.00908998 -0.00908998 + 610 0.061 0.5225918 0.52259171 2.6954176e-07 -0.0092406228 -0.0092406228 -0.0092406228 + 620 0.062 0.52295193 0.52295179 3.3545095e-07 -0.0093912234 -0.0093912234 -0.0093912234 + 630 0.063 0.52331172 0.52331152 3.9712206e-07 -0.009541781 -0.009541781 -0.009541781 + 640 0.064 0.52367116 0.52367089 4.5376114e-07 -0.0096922949 -0.0096922949 -0.0096922949 + 650 0.065 0.52403026 0.52402991 5.046345e-07 -0.0098427645 -0.0098427645 -0.0098427645 + 660 0.066 0.52438901 0.52438857 5.4907839e-07 -0.0099931892 -0.0099931892 -0.0099931892 + 670 0.067 0.5247474 0.52474687 5.8650789e-07 -0.010143568 -0.010143568 -0.010143568 + 680 0.068 0.52510544 0.52510482 6.1642481e-07 -0.010293901 -0.010293901 -0.010293901 + 690 0.069 0.52546313 0.52546241 6.3842457e-07 -0.010444186 -0.010444186 -0.010444186 + 700 0.07 0.52582047 0.52581964 6.5220194e-07 -0.010594424 -0.010594424 -0.010594424 + 710 0.071 0.52617745 0.52617651 6.5755549e-07 -0.010744614 -0.010744614 -0.010744614 + 720 0.072 0.52653407 0.52653302 6.5439079e-07 -0.010894754 -0.010894754 -0.010894754 + 730 0.073 0.52689033 0.52688917 6.4272228e-07 -0.011044845 -0.011044845 -0.011044845 + 740 0.074 0.52724622 0.52724497 6.2267365e-07 -0.011194886 -0.011194886 -0.011194886 + 750 0.075 0.52760176 0.5276004 5.944769e-07 -0.011344875 -0.011344875 -0.011344875 + 760 0.076 0.52795693 0.52795548 5.5847e-07 -0.011494813 -0.011494813 -0.011494813 + 770 0.077 0.52831174 0.5283102 5.1509307e-07 -0.011644699 -0.011644699 -0.011644699 + 780 0.078 0.52866618 0.52866456 4.6488335e-07 -0.011794531 -0.011794531 -0.011794531 + 790 0.079 0.52902025 0.52901855 4.0846871e-07 -0.01194431 -0.01194431 -0.01194431 + 800 0.08 0.52937395 0.52937219 3.465601e-07 -0.012094034 -0.012094034 -0.012094034 + 810 0.081 0.52972728 0.52972547 2.7994273e-07 -0.012243703 -0.012243703 -0.012243703 + 820 0.082 0.53008023 0.53007838 2.0946635e-07 -0.012393317 -0.012393317 -0.012393317 + 830 0.083 0.53043282 0.53043093 1.3603449e-07 -0.012542874 -0.012542874 -0.012542874 + 840 0.084 0.53078503 0.53078313 6.0593014e-08 -0.012692375 -0.012692375 -0.012692375 + 850 0.085 0.53113686 0.53113495 -1.5881986e-08 -0.012841818 -0.012841818 -0.012841818 + 860 0.086 0.53148832 0.53148642 -9.2396775e-08 -0.012991202 -0.012991202 -0.012991202 + 870 0.087 0.5318394 0.53183752 -1.6795288e-07 -0.013140528 -0.013140528 -0.013140528 + 880 0.088 0.5321901 0.53218825 -2.4156016e-07 -0.013289793 -0.013289793 -0.013289793 + 890 0.089 0.53254043 0.53253862 -3.1224982e-07 -0.013438999 -0.013438999 -0.013438999 + 900 0.09 0.53289037 0.53288862 -3.7908725e-07 -0.013588144 -0.013588144 -0.013588144 + 910 0.091 0.53323994 0.53323825 -4.4118454e-07 -0.013737227 -0.013737227 -0.013737227 + 920 0.092 0.53358913 0.53358751 -4.977124e-07 -0.013886248 -0.013886248 -0.013886248 + 930 0.093 0.53393793 0.5339364 -5.4791141e-07 -0.014035206 -0.014035206 -0.014035206 + 940 0.094 0.53428636 0.53428492 -5.9110247e-07 -0.0141841 -0.0141841 -0.0141841 + 950 0.095 0.53463441 0.53463306 -6.2669617e-07 -0.014332931 -0.014332931 -0.014332931 + 960 0.096 0.53498207 0.53498083 -6.5420112e-07 -0.014481696 -0.014481696 -0.014481696 + 970 0.097 0.53532936 0.53532822 -6.7323096e-07 -0.014630397 -0.014630397 -0.014630397 + 980 0.098 0.53567626 0.53567523 -6.8351008e-07 -0.014779031 -0.014779031 -0.014779031 + 990 0.099 0.53602279 0.53602186 -6.8487786e-07 -0.014927598 -0.014927598 -0.014927598 + 1000 0.1 0.53636893 0.53636812 -6.7729144e-07 -0.015076098 -0.015076098 -0.015076098 + 1010 0.101 0.53671469 0.53671399 -6.6082695e-07 -0.01522453 -0.01522453 -0.01522453 + 1020 0.102 0.53706008 0.53705947 -6.3567905e-07 -0.015372893 -0.015372893 -0.015372893 + 1030 0.103 0.53740508 0.53740457 -6.0215905e-07 -0.015521187 -0.015521187 -0.015521187 + 1040 0.104 0.5377497 0.53774928 -5.6069133e-07 -0.015669411 -0.015669411 -0.015669411 + 1050 0.105 0.53809394 0.53809361 -5.1180824e-07 -0.015817565 -0.015817565 -0.015817565 + 1060 0.106 0.53843779 0.53843754 -4.5614357e-07 -0.015965647 -0.015965647 -0.015965647 + 1070 0.107 0.53878127 0.53878109 -3.9442456e-07 -0.016113658 -0.016113658 -0.016113658 + 1080 0.108 0.53912436 0.53912424 -3.2746259e-07 -0.016261596 -0.016261596 -0.016261596 + 1090 0.109 0.53946708 0.539467 -2.5614276e-07 -0.016409461 -0.016409461 -0.016409461 + 1100 0.11 0.53980941 0.53980936 -1.8141231e-07 -0.016557252 -0.016557252 -0.016557252 + 1110 0.111 0.54015135 0.54015133 -1.0426816e-07 -0.016704969 -0.016704969 -0.016704969 + 1120 0.112 0.54049292 0.54049291 -2.5743734e-08 -0.016852611 -0.016852611 -0.016852611 + 1130 0.113 0.5408341 0.54083408 5.3104867e-08 -0.017000178 -0.017000178 -0.017000178 + 1140 0.114 0.5411749 0.54117486 1.3121303e-07 -0.017147668 -0.017147668 -0.017147668 + 1150 0.115 0.54151531 0.54151524 2.07522e-07 -0.017295081 -0.017295081 -0.017295081 + 1160 0.116 0.54185533 0.54185522 2.8099335e-07 -0.017442417 -0.017442417 -0.017442417 + 1170 0.117 0.54219497 0.54219481 3.5062312e-07 -0.017589675 -0.017589675 -0.017589675 + 1180 0.118 0.54253421 0.54253399 4.1545572e-07 -0.017736854 -0.017736854 -0.017736854 + 1190 0.119 0.54287307 0.54287277 4.7459715e-07 -0.017883954 -0.017883954 -0.017883954 + 1200 0.12 0.54321154 0.54321116 5.2722756e-07 -0.018030974 -0.018030974 -0.018030974 + 1210 0.121 0.54354962 0.54354914 5.7261279e-07 -0.018177914 -0.018177914 -0.018177914 + 1220 0.122 0.5438873 0.54388672 6.1011484e-07 -0.018324772 -0.018324772 -0.018324772 + 1230 0.123 0.54422459 0.54422391 6.3920113e-07 -0.018471549 -0.018471549 -0.018471549 + 1240 0.124 0.54456149 0.54456069 6.5945229e-07 -0.018618243 -0.018618243 -0.018618243 + 1250 0.125 0.54489798 0.54489707 6.7056853e-07 -0.018764854 -0.018764854 -0.018764854 + 1260 0.126 0.54523408 0.54523306 6.723743e-07 -0.018911382 -0.018911382 -0.018911382 + 1270 0.127 0.54556978 0.54556864 6.6482138e-07 -0.019057825 -0.019057825 -0.019057825 + 1280 0.128 0.54590507 0.54590383 6.4799014e-07 -0.019204184 -0.019204184 -0.019204184 + 1290 0.129 0.54623997 0.54623861 6.2208909e-07 -0.019350458 -0.019350458 -0.019350458 + 1300 0.13 0.54657445 0.546573 5.8745262e-07 -0.019496645 -0.019496645 -0.019496645 + 1310 0.131 0.54690854 0.54690699 5.4453703e-07 -0.019642746 -0.019642746 -0.019642746 + 1320 0.132 0.54724221 0.54724057 4.9391474e-07 -0.019788759 -0.019788759 -0.019788759 + 1330 0.133 0.54757548 0.54757376 4.36267e-07 -0.019934685 -0.019934685 -0.019934685 + 1340 0.134 0.54790834 0.54790655 3.7237494e-07 -0.020080523 -0.020080523 -0.020080523 + 1350 0.135 0.54824079 0.54823894 3.0310917e-07 -0.020226271 -0.020226271 -0.020226271 + 1360 0.136 0.54857283 0.54857093 2.2941816e-07 -0.02037193 -0.02037193 -0.02037193 + 1370 0.137 0.54890445 0.54890252 1.5231537e-07 -0.020517499 -0.020517499 -0.020517499 + 1380 0.138 0.54923567 0.54923371 7.2865429e-08 -0.020662978 -0.020662978 -0.020662978 + 1390 0.139 0.54956646 0.5495645 -7.830451e-09 -0.020808364 -0.020808364 -0.020808364 + 1400 0.14 0.54989685 0.54989489 -8.8649727e-08 -0.020953659 -0.020953659 -0.020953659 + 1410 0.141 0.55022681 0.55022488 -1.6846411e-07 -0.021098862 -0.021098862 -0.021098862 + 1420 0.142 0.55055637 0.55055446 -2.4615537e-07 -0.021243971 -0.021243971 -0.021243971 + 1430 0.143 0.5508855 0.55088364 -3.2063102e-07 -0.021388987 -0.021388987 -0.021388987 + 1440 0.144 0.55121422 0.55121242 -3.9083985e-07 -0.021533909 -0.021533909 -0.021533909 + 1450 0.145 0.55154253 0.55154079 -4.5578686e-07 -0.021678736 -0.021678736 -0.021678736 + 1460 0.146 0.55187041 0.55186876 -5.1454752e-07 -0.021823467 -0.021823467 -0.021823467 + 1470 0.147 0.55219788 0.55219632 -5.6628117e-07 -0.021968102 -0.021968102 -0.021968102 + 1480 0.148 0.55252494 0.55252347 -6.1024325e-07 -0.022112641 -0.022112641 -0.022112641 + 1490 0.149 0.55285157 0.55285021 -6.4579628e-07 -0.022257083 -0.022257083 -0.022257083 + 1500 0.15 0.5531778 0.55317654 -6.7241935e-07 -0.022401428 -0.022401428 -0.022401428 + 1510 0.151 0.5535036 0.55350246 -6.8971607e-07 -0.022545674 -0.022545674 -0.022545674 + 1520 0.152 0.55382899 0.55382796 -6.9742076e-07 -0.022689821 -0.022689821 -0.022689821 + 1530 0.153 0.55415396 0.55415305 -6.9540277e-07 -0.022833869 -0.022833869 -0.022833869 + 1540 0.154 0.55447852 0.55447772 -6.8366905e-07 -0.022977817 -0.022977817 -0.022977817 + 1550 0.155 0.55480267 0.55480198 -6.623646e-07 -0.023121664 -0.023121664 -0.023121664 + 1560 0.156 0.5551264 0.55512581 -6.3177108e-07 -0.023265411 -0.023265411 -0.023265411 + 1570 0.157 0.55544971 0.55544923 -5.9230341e-07 -0.023409056 -0.023409056 -0.023409056 + 1580 0.158 0.55577261 0.55577222 -5.4450444e-07 -0.023552599 -0.023552599 -0.023552599 + 1590 0.159 0.5560951 0.55609479 -4.8903776e-07 -0.023696039 -0.023696039 -0.023696039 + 1600 0.16 0.55641717 0.55641694 -4.2667879e-07 -0.023839376 -0.023839376 -0.023839376 + 1610 0.161 0.55673883 0.55673866 -3.5830415e-07 -0.023982609 -0.023982609 -0.023982609 + 1620 0.162 0.55706007 0.55705996 -2.8487954e-07 -0.024125737 -0.024125737 -0.024125737 + 1630 0.163 0.5573809 0.55738083 -2.0744627e-07 -0.024268761 -0.024268761 -0.024268761 + 1640 0.164 0.55770132 0.55770127 -1.2710666e-07 -0.02441168 -0.02441168 -0.02441168 + 1650 0.165 0.55802132 0.55802129 -4.5008398e-08 -0.024554492 -0.024554492 -0.024554492 + 1660 0.166 0.55834091 0.55834087 3.7671735e-08 -0.024697198 -0.024697198 -0.024697198 + 1670 0.167 0.55866008 0.55866003 1.1974475e-07 -0.024839797 -0.024839797 -0.024839797 + 1680 0.168 0.55897883 0.55897876 2.0002656e-07 -0.024982288 -0.024982288 -0.024982288 + 1690 0.169 0.55929717 0.55929705 2.7735509e-07 -0.025124671 -0.025124671 -0.025124671 + 1700 0.17 0.55961509 0.55961492 3.5060722e-07 -0.025266946 -0.025266946 -0.025266946 + 1710 0.171 0.5599326 0.55993235 4.187152e-07 -0.025409111 -0.025409111 -0.025409111 + 1720 0.172 0.56024968 0.56024936 4.8068242e-07 -0.025551167 -0.025551167 -0.025551167 + 1730 0.173 0.56056635 0.56056593 5.3559812e-07 -0.025693112 -0.025693112 -0.025693112 + 1740 0.174 0.56088259 0.56088208 5.8265107e-07 -0.025834947 -0.025834947 -0.025834947 + 1750 0.175 0.56119841 0.5611978 6.2114175e-07 -0.02597667 -0.02597667 -0.02597667 + 1760 0.176 0.56151381 0.56151308 6.5049306e-07 -0.026118282 -0.026118282 -0.026118282 + 1770 0.177 0.56182878 0.56182794 6.7025922e-07 -0.026259781 -0.026259781 -0.026259781 + 1780 0.178 0.56214333 0.56214237 6.8013288e-07 -0.026401167 -0.026401167 -0.026401167 + 1790 0.179 0.56245744 0.56245637 6.7995015e-07 -0.02654244 -0.02654244 -0.02654244 + 1800 0.18 0.56277113 0.56276994 6.6969368e-07 -0.026683599 -0.026683599 -0.026683599 + 1810 0.181 0.56308439 0.56308308 6.4949344e-07 -0.026824644 -0.026824644 -0.026824644 + 1820 0.182 0.56339722 0.5633958 6.1962549e-07 -0.026965574 -0.026965574 -0.026965574 + 1830 0.183 0.56370962 0.56370809 5.8050855e-07 -0.027106388 -0.027106388 -0.027106388 + 1840 0.184 0.56402158 0.56401996 5.326984e-07 -0.027247086 -0.027247086 -0.027247086 + 1850 0.185 0.56433311 0.5643314 4.7688029e-07 -0.027387668 -0.027387668 -0.027387668 + 1860 0.186 0.5646442 0.56464241 4.1385938e-07 -0.027528133 -0.027528133 -0.027528133 + 1870 0.187 0.56495486 0.564953 3.445494e-07 -0.027668481 -0.027668481 -0.027668481 + 1880 0.188 0.56526508 0.56526316 2.6995953e-07 -0.027808711 -0.027808711 -0.027808711 + 1890 0.189 0.56557486 0.5655729 1.9117995e-07 -0.027948822 -0.027948822 -0.027948822 + 1900 0.19 0.5658842 0.56588221 1.0936603e-07 -0.028088814 -0.028088814 -0.028088814 + 1910 0.191 0.5661931 0.5661911 2.5721446e-08 -0.028228687 -0.028228687 -0.028228687 + 1920 0.192 0.56650156 0.56649956 -5.8519431e-08 -0.02836844 -0.02836844 -0.02836844 + 1930 0.193 0.56680958 0.56680759 -1.4210974e-07 -0.028508072 -0.028508072 -0.028508072 + 1940 0.194 0.56711716 0.5671152 -2.2380861e-07 -0.028647584 -0.028647584 -0.028647584 + 1950 0.195 0.5674243 0.56742238 -3.0239963e-07 -0.028786974 -0.028786974 -0.028786974 + 1960 0.196 0.56773099 0.56772914 -3.7670909e-07 -0.028926242 -0.028926242 -0.028926242 + 1970 0.197 0.56803725 0.56803546 -4.456236e-07 -0.029065388 -0.029065388 -0.029065388 + 1980 0.198 0.56834306 0.56834136 -5.0810696e-07 -0.029204411 -0.029204411 -0.029204411 + 1990 0.199 0.56864844 0.56864682 -5.6321599e-07 -0.029343311 -0.029343311 -0.029343311 + 2000 0.2 0.56895337 0.56895185 -6.1011491e-07 -0.029482087 -0.029482087 -0.029482087 + 2010 0.201 0.56925786 0.56925645 -6.4808837e-07 -0.029620739 -0.029620739 -0.029620739 + 2020 0.202 0.56956192 0.56956062 -6.7655256e-07 -0.029759266 -0.029759266 -0.029759266 + 2030 0.203 0.56986553 0.56986435 -6.9506456e-07 -0.029897668 -0.029897668 -0.029897668 + 2040 0.204 0.57016871 0.57016765 -7.0332945e-07 -0.030035944 -0.030035944 -0.030035944 + 2050 0.205 0.57047145 0.5704705 -7.0120542e-07 -0.030174094 -0.030174094 -0.030174094 + 2060 0.206 0.57077375 0.57077292 -6.8870641e-07 -0.030312118 -0.030312118 -0.030312118 + 2070 0.207 0.57107561 0.5710749 -6.6600254e-07 -0.030450014 -0.030450014 -0.030450014 + 2080 0.208 0.57137704 0.57137644 -6.3341814e-07 -0.030587783 -0.030587783 -0.030587783 + 2090 0.209 0.57167803 0.57167754 -5.9142746e-07 -0.030725424 -0.030725424 -0.030725424 + 2100 0.21 0.57197859 0.57197819 -5.4064804e-07 -0.030862936 -0.030862936 -0.030862936 + 2110 0.211 0.57227872 0.5722784 -4.8183194e-07 -0.03100032 -0.03100032 -0.03100032 + 2120 0.212 0.5725784 0.57257817 -4.1585486e-07 -0.031137574 -0.031137574 -0.031137574 + 2130 0.213 0.57287766 0.57287749 -3.4370333e-07 -0.031274698 -0.031274698 -0.031274698 + 2140 0.214 0.57317648 0.57317636 -2.6646013e-07 -0.031411692 -0.031411692 -0.031411692 + 2150 0.215 0.57347487 0.57347478 -1.8528826e-07 -0.031548556 -0.031548556 -0.031548556 + 2160 0.216 0.57377282 0.57377276 -1.0141351e-07 -0.031685288 -0.031685288 -0.031685288 + 2170 0.217 0.57407034 0.57407029 -1.6106051e-08 -0.031821889 -0.031821889 -0.031821889 + 2180 0.218 0.57436743 0.57436736 6.9338743e-08 -0.031958358 -0.031958358 -0.031958358 + 2190 0.219 0.57466408 0.57466399 1.5361998e-07 -0.032094694 -0.032094694 -0.032094694 + 2200 0.22 0.57496029 0.57496017 2.3545107e-07 -0.032230897 -0.032230897 -0.032230897 + 2210 0.221 0.57525608 0.57525591 3.1357945e-07 -0.032366967 -0.032366967 -0.032366967 + 2220 0.222 0.57555142 0.57555119 3.8680589e-07 -0.032502904 -0.032502904 -0.032502904 + 2230 0.223 0.57584633 0.57584602 4.54003e-07 -0.032638706 -0.032638706 -0.032638706 + 2240 0.224 0.5761408 0.57614041 5.1413283e-07 -0.032774373 -0.032774373 -0.032774373 + 2250 0.225 0.57643483 0.57643434 5.6626308e-07 -0.032909906 -0.032909906 -0.032909906 + 2260 0.226 0.57672843 0.57672783 6.0958183e-07 -0.033045303 -0.033045303 -0.033045303 + 2270 0.227 0.57702158 0.57702087 6.4341044e-07 -0.033180564 -0.033180564 -0.033180564 + 2280 0.228 0.5773143 0.57731347 6.6721445e-07 -0.033315689 -0.033315689 -0.033315689 + 2290 0.229 0.57760657 0.57760562 6.8061239e-07 -0.033450677 -0.033450677 -0.033450677 + 2300 0.23 0.57789839 0.57789732 6.8338214e-07 -0.033585528 -0.033585528 -0.033585528 + 2310 0.231 0.57818977 0.57818858 6.7546495e-07 -0.033720241 -0.033720241 -0.033720241 + 2320 0.232 0.57848071 0.5784794 6.5696693e-07 -0.033854817 -0.033854817 -0.033854817 + 2330 0.233 0.5787712 0.57876977 6.2815797e-07 -0.033989254 -0.033989254 -0.033989254 + 2340 0.234 0.57906124 0.5790597 5.8946815e-07 -0.034123552 -0.034123552 -0.034123552 + 2350 0.235 0.57935083 0.57934919 5.4148162e-07 -0.034257711 -0.034257711 -0.034257711 + 2360 0.236 0.57963997 0.57963824 4.8492805e-07 -0.034391731 -0.034391731 -0.034391731 + 2370 0.237 0.57992866 0.57992685 4.2067186e-07 -0.03452561 -0.03452561 -0.03452561 + 2380 0.238 0.5802169 0.58021501 3.496992e-07 -0.03465935 -0.03465935 -0.03465935 + 2390 0.239 0.58050468 0.58050274 2.73103e-07 -0.034792948 -0.034792948 -0.034792948 + 2400 0.24 0.58079201 0.58079003 1.9206639e-07 -0.034926405 -0.034926405 -0.034926405 + 2410 0.241 0.58107889 0.58107688 1.078445e-07 -0.035059721 -0.035059721 -0.035059721 + 2420 0.242 0.58136532 0.58136329 2.1745102e-08 -0.035192895 -0.035192895 -0.035192895 + 2430 0.243 0.58165129 0.58164926 -6.4891571e-08 -0.035325926 -0.035325926 -0.035325926 + 2440 0.244 0.5819368 0.58193479 -1.5071374e-07 -0.035458815 -0.035458815 -0.035458815 + 2450 0.245 0.58222186 0.58221988 -2.3437916e-07 -0.035591561 -0.035591561 -0.035591561 + 2460 0.246 0.58250646 0.58250453 -3.145762e-07 -0.035724163 -0.035724163 -0.035724163 + 2470 0.247 0.58279061 0.58278874 -3.900445e-07 -0.035856621 -0.035856621 -0.035856621 + 2480 0.248 0.58307431 0.58307251 -4.5959495e-07 -0.035988935 -0.035988935 -0.035988935 + 2490 0.249 0.58335755 0.58335584 -5.2212856e-07 -0.036121105 -0.036121105 -0.036121105 + 2500 0.25 0.58364034 0.58363872 -5.7665408e-07 -0.036253129 -0.036253129 -0.036253129 + 2510 0.251 0.58392268 0.58392116 -6.2230397e-07 -0.036385008 -0.036385008 -0.036385008 + 2520 0.252 0.58420456 0.58420316 -6.583484e-07 -0.036516742 -0.036516742 -0.036516742 + 2530 0.253 0.584486 0.58448471 -6.842073e-07 -0.036648329 -0.036648329 -0.036648329 + 2540 0.254 0.58476698 0.58476581 -6.9945994e-07 -0.03677977 -0.03677977 -0.03677977 + 2550 0.255 0.58504751 0.58504647 -7.0385209e-07 -0.036911064 -0.036911064 -0.036911064 + 2560 0.256 0.5853276 0.58532668 -6.9730063e-07 -0.037042211 -0.037042211 -0.037042211 + 2570 0.257 0.58560724 0.58560643 -6.7989533e-07 -0.03717321 -0.03717321 -0.03717321 + 2580 0.258 0.58588642 0.58588574 -6.5189807e-07 -0.037304062 -0.037304062 -0.037304062 + 2590 0.259 0.58616517 0.58616459 -6.1373914e-07 -0.037434765 -0.037434765 -0.037434765 + 2600 0.26 0.58644347 0.586443 -5.66011e-07 -0.03756532 -0.03756532 -0.03756532 + 2610 0.261 0.58672132 0.58672094 -5.0945935e-07 -0.037695726 -0.037695726 -0.037695726 + 2620 0.262 0.58699873 0.58699843 -4.4497175e-07 -0.037825982 -0.037825982 -0.037825982 + 2630 0.263 0.5872757 0.58727547 -3.7356393e-07 -0.037956089 -0.037956089 -0.037956089 + 2640 0.264 0.58755222 0.58755205 -2.9636401e-07 -0.038086046 -0.038086046 -0.038086046 + 2650 0.265 0.5878283 0.58782817 -2.1459483e-07 -0.038215852 -0.038215852 -0.038215852 + 2660 0.266 0.58810394 0.58810384 -1.2955473e-07 -0.038345508 -0.038345508 -0.038345508 + 2670 0.267 0.58837913 0.58837905 -4.2597042e-08 -0.038475013 -0.038475013 -0.038475013 + 2680 0.268 0.58865388 0.5886538 4.489141e-08 -0.038604367 -0.038604367 -0.038604367 + 2690 0.269 0.5889282 0.58892809 1.315124e-07 -0.038733569 -0.038733569 -0.038733569 + 2700 0.27 0.58920206 0.58920193 2.1587867e-07 -0.038862619 -0.038862619 -0.038862619 + 2710 0.271 0.58947549 0.5894753 2.9663624e-07 -0.038991516 -0.038991516 -0.038991516 + 2720 0.272 0.58974847 0.58974823 3.724862e-07 -0.039120262 -0.039120262 -0.039120262 + 2730 0.273 0.59002101 0.59002069 4.422058e-07 -0.039248854 -0.039248854 -0.039248854 + 2740 0.274 0.59029311 0.5902927 5.0466829e-07 -0.039377293 -0.039377293 -0.039377293 + 2750 0.275 0.59056476 0.59056425 5.5886139e-07 -0.039505578 -0.039505578 -0.039505578 + 2760 0.276 0.59083596 0.59083534 6.0390391e-07 -0.039633709 -0.039633709 -0.039633709 + 2770 0.277 0.59110672 0.59110599 6.3906037e-07 -0.039761687 -0.039761687 -0.039761687 + 2780 0.278 0.59137702 0.59137617 6.6375325e-07 -0.039889509 -0.039889509 -0.039889509 + 2790 0.279 0.59164688 0.59164591 6.7757286e-07 -0.040017177 -0.040017177 -0.040017177 + 2800 0.28 0.59191629 0.5919152 6.8028436e-07 -0.04014469 -0.04014469 -0.04014469 + 2810 0.281 0.59218525 0.59218403 6.7183215e-07 -0.040272047 -0.040272047 -0.040272047 + 2820 0.282 0.59245376 0.59245242 6.5234123e-07 -0.040399248 -0.040399248 -0.040399248 + 2830 0.283 0.59272182 0.59272035 6.221157e-07 -0.040526294 -0.040526294 -0.040526294 + 2840 0.284 0.59298942 0.59298784 5.8163434e-07 -0.040653183 -0.040653183 -0.040653183 + 2850 0.285 0.59325656 0.59325489 5.3154333e-07 -0.040779915 -0.040779915 -0.040779915 + 2860 0.286 0.59352325 0.59352148 4.7264622e-07 -0.040906491 -0.040906491 -0.040906491 + 2870 0.287 0.59378949 0.59378764 4.0589128e-07 -0.041032909 -0.041032909 -0.041032909 + 2880 0.288 0.59405526 0.59405334 3.3235647e-07 -0.04115917 -0.04115917 -0.04115917 + 2890 0.289 0.59432058 0.59431861 2.5323221e-07 -0.041285273 -0.041285273 -0.041285273 + 2900 0.29 0.59458544 0.59458343 1.6980231e-07 -0.041411218 -0.041411218 -0.041411218 + 2910 0.291 0.59484984 0.59484781 8.3423201e-08 -0.041537004 -0.041537004 -0.041537004 + 2920 0.292 0.59511379 0.59511174 -4.4979772e-09 -0.041662632 -0.041662632 -0.041662632 + 2930 0.293 0.59537727 0.59537523 -9.25263e-08 -0.041788101 -0.041788101 -0.041788101 + 2940 0.294 0.5956403 0.59563828 -1.7922246e-07 -0.041913411 -0.041913411 -0.041913411 + 2950 0.295 0.59590287 0.59590089 -2.6316634e-07 -0.042038561 -0.042038561 -0.042038561 + 2960 0.296 0.59616498 0.59616305 -3.4298038e-07 -0.042163552 -0.042163552 -0.042163552 + 2970 0.297 0.59642663 0.59642477 -4.1735227e-07 -0.042288382 -0.042288382 -0.042288382 + 2980 0.298 0.59668783 0.59668604 -4.8505673e-07 -0.042413052 -0.042413052 -0.042413052 + 2990 0.299 0.59694857 0.59694687 -5.4497585e-07 -0.042537562 -0.042537562 -0.042537562 + 3000 0.3 0.59720885 0.59720726 -5.9611782e-07 -0.04266191 -0.04266191 -0.04266191 + 3010 0.301 0.59746868 0.5974672 -6.3763354e-07 -0.042786098 -0.042786098 -0.042786098 + 3020 0.302 0.59772805 0.59772669 -6.6883106e-07 -0.042910124 -0.042910124 -0.042910124 + 3030 0.303 0.59798698 0.59798573 -6.8918737e-07 -0.043033989 -0.043033989 -0.043033989 + 3040 0.304 0.59824545 0.59824433 -6.9835748e-07 -0.043157692 -0.043157692 -0.043157692 + 3050 0.305 0.59850347 0.59850247 -6.9618058e-07 -0.043281233 -0.043281233 -0.043281233 + 3060 0.306 0.59876104 0.59876017 -6.826832e-07 -0.043404611 -0.043404611 -0.043404611 + 3070 0.307 0.59901816 0.59901741 -6.5807923e-07 -0.043527827 -0.043527827 -0.043527827 + 3080 0.308 0.59927483 0.5992742 -6.2276684e-07 -0.04365088 -0.04365088 -0.04365088 + 3090 0.309 0.59953106 0.59953053 -5.7732236e-07 -0.04377377 -0.04377377 -0.04377377 + 3100 0.31 0.59978685 0.59978641 -5.2249119e-07 -0.043896496 -0.043896496 -0.043896496 + 3110 0.311 0.60004219 0.60004184 -4.5917576e-07 -0.044019059 -0.044019059 -0.044019059 + 3120 0.312 0.60029708 0.60029681 -3.8842101e-07 -0.044141458 -0.044141458 -0.044141458 + 3130 0.313 0.60055153 0.60055132 -3.113973e-07 -0.044263693 -0.044263693 -0.044263693 + 3140 0.314 0.60080554 0.60080538 -2.2938121e-07 -0.044385764 -0.044385764 -0.044385764 + 3150 0.315 0.60105911 0.60105898 -1.4373457e-07 -0.04450767 -0.04450767 -0.04450767 + 3160 0.316 0.60131224 0.60131212 -5.5881936e-08 -0.044629411 -0.044629411 -0.044629411 + 3170 0.317 0.60156492 0.60156481 3.2713085e-08 -0.044750988 -0.044750988 -0.044750988 + 3180 0.318 0.60181717 0.60181703 1.2057216e-07 -0.044872399 -0.044872399 -0.044872399 + 3190 0.319 0.60206897 0.6020688 2.0622692e-07 -0.044993645 -0.044993645 -0.044993645 + 3200 0.32 0.60232033 0.60232012 2.882436e-07 -0.045114725 -0.045114725 -0.045114725 + 3210 0.321 0.60257125 0.60257097 3.6524711e-07 -0.045235639 -0.045235639 -0.045235639 + 3220 0.322 0.60282173 0.60282137 4.3594424e-07 -0.045356388 -0.045356388 -0.045356388 + 3230 0.323 0.60307176 0.60307132 4.9914554e-07 -0.045476969 -0.045476969 -0.045476969 + 3240 0.324 0.60332135 0.60332081 5.537856e-07 -0.045597385 -0.045597385 -0.045597385 + 3250 0.325 0.6035705 0.60356985 5.9894116e-07 -0.045717634 -0.045717634 -0.045717634 + 3260 0.326 0.60381921 0.60381844 6.3384706e-07 -0.045837715 -0.045837715 -0.045837715 + 3270 0.327 0.60406746 0.60406658 6.5790942e-07 -0.04595763 -0.04595763 -0.04595763 + 3280 0.328 0.60431528 0.60431427 6.7071607e-07 -0.046077377 -0.046077377 -0.046077377 + 3290 0.329 0.60456264 0.6045615 6.7204395e-07 -0.046196957 -0.046196957 -0.046196957 + 3300 0.33 0.60480956 0.6048083 6.6186325e-07 -0.046316369 -0.046316369 -0.046316369 + 3310 0.331 0.60505602 0.60505464 6.4033837e-07 -0.046435613 -0.046435613 -0.046435613 + 3320 0.332 0.60530204 0.60530054 6.0782561e-07 -0.046554689 -0.046554689 -0.046554689 + 3330 0.333 0.60554761 0.605546 5.6486753e-07 -0.046673597 -0.046673597 -0.046673597 + 3340 0.334 0.60579272 0.60579101 5.1218422e-07 -0.046792336 -0.046792336 -0.046792336 + 3350 0.335 0.60603738 0.60603558 4.5066146e-07 -0.046910906 -0.046910906 -0.046910906 + 3360 0.336 0.60628159 0.60627971 3.8133609e-07 -0.047029308 -0.047029308 -0.047029308 + 3370 0.337 0.60652535 0.6065234 3.0537872e-07 -0.04714754 -0.04714754 -0.04714754 + 3380 0.338 0.60676865 0.60676665 2.2407417e-07 -0.047265604 -0.047265604 -0.047265604 + 3390 0.339 0.6070115 0.60700946 1.3879984e-07 -0.047383497 -0.047383497 -0.047383497 + 3400 0.34 0.60725389 0.60725184 5.1002519e-08 -0.047501222 -0.047501222 -0.047501222 + 3410 0.341 0.60749583 0.60749377 -3.7826124e-08 -0.047618776 -0.047618776 -0.047618776 + 3420 0.342 0.60773732 0.60773527 -1.2617486e-07 -0.04773616 -0.04773616 -0.04773616 + 3430 0.343 0.60797835 0.60797633 -2.1253862e-07 -0.047853375 -0.047853375 -0.047853375 + 3440 0.344 0.60821893 0.60821696 -2.9544421e-07 -0.047970419 -0.047970419 -0.047970419 + 3450 0.345 0.60845905 0.60845714 -3.734755e-07 -0.048087292 -0.048087292 -0.048087292 + 3460 0.346 0.60869873 0.60869689 -4.4529782e-07 -0.048203995 -0.048203995 -0.048203995 + 3470 0.347 0.60893795 0.6089362 -5.0968088e-07 -0.048320527 -0.048320527 -0.048320527 + 3480 0.348 0.60917672 0.60917507 -5.655201e-07 -0.048436888 -0.048436888 -0.048436888 + 3490 0.349 0.60941504 0.60941349 -6.118558e-07 -0.048553078 -0.048553078 -0.048553078 + 3500 0.35 0.60965292 0.60965148 -6.4788989e-07 -0.048669097 -0.048669097 -0.048669097 + 3510 0.351 0.60989034 0.60988903 -6.7299997e-07 -0.048784944 -0.048784944 -0.048784944 + 3520 0.352 0.61012732 0.61012613 -6.8675033e-07 -0.048900619 -0.048900619 -0.048900619 + 3530 0.353 0.61036386 0.6103628 -6.8889983e-07 -0.049016123 -0.049016123 -0.049016123 + 3540 0.354 0.61059995 0.61059901 -6.7940642e-07 -0.049131455 -0.049131455 -0.049131455 + 3550 0.355 0.6108356 0.61083479 -6.5842829e-07 -0.049246615 -0.049246615 -0.049246615 + 3560 0.356 0.61107081 0.61107011 -6.2632151e-07 -0.049361603 -0.049361603 -0.049361603 + 3570 0.357 0.61130559 0.611305 -5.836343e-07 -0.049476418 -0.049476418 -0.049476418 + 3580 0.358 0.61153992 0.61153943 -5.3109794e-07 -0.049591061 -0.049591061 -0.049591061 + 3590 0.359 0.61177381 0.61177342 -4.6961453e-07 -0.049705531 -0.049705531 -0.049705531 + 3600 0.36 0.61200727 0.61200695 -4.0024169e-07 -0.049819829 -0.049819829 -0.049819829 + 3610 0.361 0.6122403 0.61224004 -3.241746e-07 -0.049933953 -0.049933953 -0.049933953 + 3620 0.362 0.61247289 0.61247268 -2.4272558e-07 -0.050047905 -0.050047905 -0.050047905 + 3630 0.363 0.61270504 0.61270487 -1.5730157e-07 -0.050161683 -0.050161683 -0.050161683 + 3640 0.364 0.61293677 0.61293661 -6.937997e-08 -0.050275289 -0.050275289 -0.050275289 + 3650 0.365 0.61316806 0.6131679 1.9516899e-08 -0.05038872 -0.05038872 -0.05038872 + 3660 0.366 0.61339891 0.61339875 1.078481e-07 -0.050501979 -0.050501979 -0.050501979 + 3670 0.367 0.61362934 0.61362914 1.9408082e-07 -0.050615063 -0.050615063 -0.050615063 + 3680 0.368 0.61385933 0.61385909 2.7671704e-07 -0.050727974 -0.050727974 -0.050727974 + 3690 0.369 0.61408889 0.61408858 3.543196e-07 -0.050840711 -0.050840711 -0.050840711 + 3700 0.37 0.61431802 0.61431763 4.2553742e-07 -0.050953274 -0.050953274 -0.050953274 + 3710 0.371 0.61454671 0.61454624 4.891291e-07 -0.051065662 -0.051065662 -0.051065662 + 3720 0.372 0.61477497 0.6147744 5.4398482e-07 -0.051177877 -0.051177877 -0.051177877 + 3730 0.373 0.61500279 0.61500212 5.8914589e-07 -0.051289917 -0.051289917 -0.051289917 + 3740 0.374 0.61523018 0.61522939 6.2382182e-07 -0.051401782 -0.051401782 -0.051401782 + 3750 0.375 0.61545714 0.61545622 6.4740433e-07 -0.051513473 -0.051513473 -0.051513473 + 3760 0.376 0.61568366 0.61568261 6.5947843e-07 -0.05162499 -0.05162499 -0.05162499 + 3770 0.377 0.61590974 0.61590857 6.598299e-07 -0.051736331 -0.051736331 -0.051736331 + 3780 0.378 0.61613538 0.61613409 6.4844946e-07 -0.051847498 -0.051847498 -0.051847498 + 3790 0.379 0.61636058 0.61635917 6.2553327e-07 -0.05195849 -0.05195849 -0.05195849 + 3800 0.38 0.61658534 0.61658381 5.9147985e-07 -0.052069306 -0.052069306 -0.052069306 + 3810 0.381 0.61680966 0.61680803 5.4688338e-07 -0.052179947 -0.052179947 -0.052179947 + 3820 0.382 0.61703355 0.61703181 4.9252369e-07 -0.052290414 -0.052290414 -0.052290414 + 3830 0.383 0.61725699 0.61725516 4.2935278e-07 -0.052400704 -0.052400704 -0.052400704 + 3840 0.384 0.61747998 0.61747808 3.5847842e-07 -0.05251082 -0.05251082 -0.05251082 + 3850 0.385 0.61770254 0.61770057 2.811449e-07 -0.052620759 -0.052620759 -0.052620759 + 3860 0.386 0.61792465 0.61792263 1.9871133e-07 -0.052730523 -0.052730523 -0.052730523 + 3870 0.387 0.61814632 0.61814427 1.126279e-07 -0.052840112 -0.052840112 -0.052840112 + 3880 0.388 0.61836754 0.61836548 2.4410428e-08 -0.052949524 -0.052949524 -0.052949524 + 3890 0.389 0.61858832 0.61858626 -6.4386247e-08 -0.053058761 -0.053058761 -0.053058761 + 3900 0.39 0.61880866 0.61880662 -1.521957e-07 -0.053167821 -0.053167821 -0.053167821 + 3910 0.391 0.61902856 0.61902656 -2.3746757e-07 -0.053276706 -0.053276706 -0.053276706 + 3920 0.392 0.61924802 0.61924606 -3.1869499e-07 -0.053385414 -0.053385414 -0.053385414 + 3930 0.393 0.61946703 0.61946514 -3.9444133e-07 -0.053493947 -0.053493947 -0.053493947 + 3940 0.394 0.61968561 0.6196838 -4.6336578e-07 -0.053602303 -0.053602303 -0.053602303 + 3950 0.395 0.61990374 0.61990202 -5.2424718e-07 -0.053710482 -0.053710482 -0.053710482 + 3960 0.396 0.62012144 0.62011982 -5.7600597e-07 -0.053818486 -0.053818486 -0.053818486 + 3970 0.397 0.62033871 0.6203372 -6.1772348e-07 -0.053926313 -0.053926313 -0.053926313 + 3980 0.398 0.62055553 0.62055414 -6.486585e-07 -0.054033963 -0.054033963 -0.054033963 + 3990 0.399 0.62077193 0.62077066 -6.6826077e-07 -0.054141436 -0.054141436 -0.054141436 + 4000 0.4 0.62098789 0.62098674 -6.7618099e-07 -0.054248733 -0.054248733 -0.054248733 + 4010 0.401 0.62120342 0.6212024 -6.7227739e-07 -0.054355854 -0.054355854 -0.054355854 + 4020 0.402 0.62141852 0.62141762 -6.566185e-07 -0.054462797 -0.054462797 -0.054462797 + 4030 0.403 0.62163319 0.62163242 -6.294823e-07 -0.054569564 -0.054569564 -0.054569564 + 4040 0.404 0.62184744 0.62184677 -5.9135153e-07 -0.054676154 -0.054676154 -0.054676154 + 4050 0.405 0.62206126 0.6220607 -5.4290537e-07 -0.054782567 -0.054782567 -0.054782567 + 4060 0.406 0.62227466 0.62227419 -4.850076e-07 -0.054888803 -0.054888803 -0.054888803 + 4070 0.407 0.62248763 0.62248725 -4.1869146e-07 -0.054994861 -0.054994861 -0.054994861 + 4080 0.408 0.62270018 0.62269987 -3.4514137e-07 -0.055100743 -0.055100743 -0.055100743 + 4090 0.409 0.62291232 0.62291206 -2.6567194e-07 -0.055206448 -0.055206448 -0.055206448 + 4100 0.41 0.62312403 0.62312381 -1.8170469e-07 -0.055311975 -0.055311975 -0.055311975 + 4110 0.411 0.62333532 0.62333513 -9.4742642e-08 -0.055417325 -0.055417325 -0.055417325 + 4120 0.412 0.6235462 0.62354601 -6.3435298e-09 -0.055522499 -0.055522499 -0.055522499 + 4130 0.413 0.62375665 0.62375645 8.1908081e-08 -0.055627494 -0.055627494 -0.055627494 + 4140 0.414 0.62396669 0.62396646 1.6842921e-07 -0.055732313 -0.055732313 -0.055732313 + 4150 0.415 0.62417631 0.62417604 2.5166689e-07 -0.055836954 -0.055836954 -0.055836954 + 4160 0.416 0.62438551 0.62438518 3.3012615e-07 -0.055941417 -0.055941417 -0.055941417 + 4170 0.417 0.6245943 0.6245939 4.0239694e-07 -0.056045704 -0.056045704 -0.056045704 + 4180 0.418 0.62480266 0.62480218 4.6717967e-07 -0.056149812 -0.056149812 -0.056149812 + 4190 0.419 0.62501061 0.62501003 5.2330875e-07 -0.056253744 -0.056253744 -0.056253744 + 4200 0.42 0.62521814 0.62521745 5.6977374e-07 -0.056357498 -0.056357498 -0.056357498 + 4210 0.421 0.62542525 0.62542444 6.057378e-07 -0.056461074 -0.056461074 -0.056461074 + 4220 0.422 0.62563194 0.62563101 6.3055304e-07 -0.056564473 -0.056564473 -0.056564473 + 4230 0.423 0.6258382 0.62583716 6.4377238e-07 -0.056667694 -0.056667694 -0.056667694 + 4240 0.424 0.62604405 0.62604288 6.4515798e-07 -0.056770738 -0.056770738 -0.056770738 + 4250 0.425 0.62624947 0.62624817 6.3468571e-07 -0.056873604 -0.056873604 -0.056873604 + 4260 0.426 0.62645447 0.62645305 6.1254589e-07 -0.056976292 -0.056976292 -0.056976292 + 4270 0.427 0.62665905 0.62665751 5.7914013e-07 -0.057078803 -0.057078803 -0.057078803 + 4280 0.428 0.6268632 0.62686155 5.3507424e-07 -0.057181136 -0.057181136 -0.057181136 + 4290 0.429 0.62706692 0.62706518 4.8114756e-07 -0.057283292 -0.057283292 -0.057283292 + 4300 0.43 0.62727022 0.62726839 4.1833866e-07 -0.057385269 -0.057385269 -0.057385269 + 4310 0.431 0.6274731 0.62747119 3.4778776e-07 -0.05748707 -0.05748707 -0.05748707 + 4320 0.432 0.62767554 0.62767358 2.7077627e-07 -0.057588692 -0.057588692 -0.057588692 + 4330 0.433 0.62787756 0.62787555 1.8870359e-07 -0.057690137 -0.057690137 -0.057690137 + 4340 0.434 0.62807916 0.62807712 1.0306185e-07 -0.057791404 -0.057791404 -0.057791404 + 4350 0.435 0.62828033 0.62827827 1.5408826e-08 -0.057892494 -0.057892494 -0.057892494 + 4360 0.436 0.62848107 0.62847902 -7.2660336e-08 -0.057993406 -0.057993406 -0.057993406 + 4370 0.437 0.62868138 0.62867935 -1.5954216e-07 -0.05809414 -0.05809414 -0.05809414 + 4380 0.438 0.62888127 0.62887928 -2.4365405e-07 -0.058194696 -0.058194696 -0.058194696 + 4390 0.439 0.62908074 0.6290788 -3.2346322e-07 -0.058295075 -0.058295075 -0.058295075 + 4400 0.44 0.62927978 0.62927791 -3.9751471e-07 -0.058395277 -0.058395277 -0.058395277 + 4410 0.441 0.6294784 0.62947661 -4.6445802e-07 -0.0584953 -0.0584953 -0.0584953 + 4420 0.442 0.6296766 0.6296749 -5.2307198e-07 -0.058595146 -0.058595146 -0.058595146 + 4430 0.443 0.62987438 0.62987278 -5.7228716e-07 -0.058694815 -0.058694815 -0.058694815 + 4440 0.444 0.63007174 0.63007025 -6.1120565e-07 -0.058794305 -0.058794305 -0.058794305 + 4450 0.445 0.63026869 0.63026731 -6.3911762e-07 -0.058893618 -0.058893618 -0.058893618 + 4460 0.446 0.63046521 0.63046396 -6.5551459e-07 -0.058992754 -0.058992754 -0.058992754 + 4470 0.447 0.63066133 0.6306602 -6.6009891e-07 -0.059091712 -0.059091712 -0.059091712 + 4480 0.448 0.63085703 0.63085602 -6.5278946e-07 -0.059190493 -0.059190493 -0.059190493 + 4490 0.449 0.63105232 0.63105143 -6.3372335e-07 -0.059289096 -0.059289096 -0.059289096 + 4500 0.45 0.6312472 0.63124643 -6.032536e-07 -0.059387521 -0.059387521 -0.059387521 + 4510 0.451 0.63144167 0.63144101 -5.6194288e-07 -0.05948577 -0.05948577 -0.05948577 + 4520 0.452 0.63163573 0.63163518 -5.1055337e-07 -0.05958384 -0.05958384 -0.05958384 + 4530 0.453 0.6318294 0.63182893 -4.500329e-07 -0.059681734 -0.059681734 -0.059681734 + 4540 0.454 0.63202265 0.63202226 -3.8149769e-07 -0.05977945 -0.05977945 -0.05977945 + 4550 0.455 0.63221551 0.63221518 -3.0621194e-07 -0.059876988 -0.059876988 -0.059876988 + 4560 0.456 0.63240796 0.63240768 -2.2556465e-07 -0.05997435 -0.05997435 -0.05997435 + 4570 0.457 0.63260001 0.63259976 -1.4104413e-07 -0.060071534 -0.060071534 -0.060071534 + 4580 0.458 0.63279166 0.63279143 -5.4210581e-08 -0.06016854 -0.06016854 -0.06016854 + 4590 0.459 0.63298291 0.63298268 3.3332623e-08 -0.06026537 -0.06026537 -0.06026537 + 4600 0.46 0.63317376 0.63317351 1.1996854e-07 -0.060362023 -0.060362023 -0.060362023 + 4610 0.461 0.63336422 0.63336393 2.0409657e-07 -0.060458498 -0.060458498 -0.060458498 + 4620 0.462 0.63355427 0.63355394 2.8416203e-07 -0.060554796 -0.060554796 -0.060554796 + 4630 0.463 0.63374393 0.63374353 3.5868507e-07 -0.060650918 -0.060650918 -0.060650918 + 4640 0.464 0.63393318 0.6339327 4.2628804e-07 -0.060746862 -0.060746862 -0.060746862 + 4650 0.465 0.63412204 0.63412147 4.8572121e-07 -0.060842629 -0.060842629 -0.060842629 + 4660 0.466 0.6343105 0.63430983 5.35886e-07 -0.06093822 -0.06093822 -0.06093822 + 4670 0.467 0.63449856 0.63449778 5.7585552e-07 -0.061033634 -0.061033634 -0.061033634 + 4680 0.468 0.63468622 0.63468532 6.048919e-07 -0.06112887 -0.06112887 -0.06112887 + 4690 0.469 0.63487347 0.63487245 6.2246016e-07 -0.061223931 -0.061223931 -0.061223931 + 4700 0.47 0.63506033 0.63505918 6.2823833e-07 -0.061318814 -0.061318814 -0.061318814 + 4710 0.471 0.63524678 0.63524551 6.2212359e-07 -0.061413521 -0.061413521 -0.061413521 + 4720 0.472 0.63543283 0.63543144 6.0423435e-07 -0.061508051 -0.061508051 -0.061508051 + 4730 0.473 0.63561847 0.63561697 5.7490826e-07 -0.061602405 -0.061602405 -0.061602405 + 4740 0.474 0.63580371 0.6358021 5.3469601e-07 -0.061696582 -0.061696582 -0.061696582 + 4750 0.475 0.63598855 0.63598684 4.8435128e-07 -0.061790583 -0.061790583 -0.061790583 + 4760 0.476 0.63617298 0.63617118 4.2481683e-07 -0.061884408 -0.061884408 -0.061884408 + 4770 0.477 0.63635701 0.63635512 3.5720699e-07 -0.061978056 -0.061978056 -0.061978056 + 4780 0.478 0.63654062 0.63653868 2.8278703e-07 -0.062071529 -0.062071529 -0.062071529 + 4790 0.479 0.63672384 0.63672184 2.0294959e-07 -0.062164825 -0.062164825 -0.062164825 + 4800 0.48 0.63690664 0.63690461 1.1918874e-07 -0.062257945 -0.062257945 -0.062257945 + 4810 0.481 0.63708904 0.637087 3.3072095e-08 -0.062350889 -0.062350889 -0.062350889 + 4820 0.482 0.63727104 0.63726899 -5.3788471e-08 -0.062443657 -0.062443657 -0.062443657 + 4830 0.483 0.63745263 0.6374506 -1.39767e-07 -0.062536249 -0.062536249 -0.062536249 + 4840 0.484 0.63763381 0.63763182 -2.2325389e-07 -0.062628665 -0.062628665 -0.062628665 + 4850 0.485 0.63781459 0.63781265 -3.0268612e-07 -0.062720906 -0.062720906 -0.062720906 + 4860 0.486 0.63799497 0.63799309 -3.7657657e-07 -0.062812971 -0.062812971 -0.062812971 + 4870 0.487 0.63817495 0.63817314 -4.4354199e-07 -0.062904861 -0.062904861 -0.062904861 + 4880 0.488 0.63835452 0.63835281 -5.0232909e-07 -0.062996575 -0.062996575 -0.062996575 + 4890 0.489 0.6385337 0.63853208 -5.5183811e-07 -0.063088114 -0.063088114 -0.063088114 + 4900 0.49 0.63871248 0.63871097 -5.9114363e-07 -0.063179477 -0.063179477 -0.063179477 + 4910 0.491 0.63889086 0.63888947 -6.1951209e-07 -0.063270665 -0.063270665 -0.063270665 + 4920 0.492 0.63906885 0.63906758 -6.3641568e-07 -0.063361678 -0.063361678 -0.063361678 + 4930 0.493 0.63924644 0.6392453 -6.4154246e-07 -0.063452516 -0.063452516 -0.063452516 + 4940 0.494 0.63942365 0.63942262 -6.3480228e-07 -0.063543179 -0.063543179 -0.063543179 + 4950 0.495 0.63960046 0.63959956 -6.1632869e-07 -0.063633667 -0.063633667 -0.063633667 + 4960 0.496 0.63977689 0.6397761 -5.8647648e-07 -0.063723981 -0.063723981 -0.063723981 + 4970 0.497 0.63995293 0.63995224 -5.4581515e-07 -0.063814119 -0.063814119 -0.063814119 + 4980 0.498 0.64012859 0.640128 -4.9511825e-07 -0.063904083 -0.063904083 -0.063904083 + 4990 0.499 0.64030386 0.64030336 -4.3534885e-07 -0.063993873 -0.063993873 -0.063993873 + 5000 0.5 0.64047875 0.64047832 -3.6764149e-07 -0.064083488 -0.064083488 -0.064083488 + 5010 0.501 0.64065325 0.64065289 -2.9328075e-07 -0.064172929 -0.064172929 -0.064172929 + 5020 0.502 0.64082738 0.64082707 -2.1367704e-07 -0.064262195 -0.064262195 -0.064262195 + 5030 0.503 0.64100113 0.64100085 -1.3033993e-07 -0.064351288 -0.064351288 -0.064351288 + 5040 0.504 0.6411745 0.64117423 -4.4849648e-08 -0.064440206 -0.064440206 -0.064440206 + 5050 0.505 0.6413475 0.64134722 4.1172909e-08 -0.06452895 -0.06452895 -0.06452895 + 5060 0.506 0.64152011 0.64151982 1.2609686e-07 -0.064617521 -0.064617521 -0.064617521 + 5070 0.507 0.64169236 0.64169202 2.0831228e-07 -0.064705918 -0.064705918 -0.064705918 + 5080 0.508 0.64186422 0.64186384 2.8626081e-07 -0.064794141 -0.064794141 -0.064794141 + 5090 0.509 0.64203571 0.64203526 3.5846527e-07 -0.064882191 -0.064882191 -0.064882191 + 5100 0.51 0.64220682 0.64220629 4.2355775e-07 -0.064970067 -0.064970067 -0.064970067 + 5110 0.511 0.64237755 0.64237693 4.8030571e-07 -0.06505777 -0.06505777 -0.06505777 + 5120 0.512 0.64254791 0.64254719 5.2763546e-07 -0.0651453 -0.0651453 -0.0651453 + 5130 0.513 0.64271789 0.64271705 5.6465267e-07 -0.065232657 -0.065232657 -0.065232657 + 5140 0.514 0.64288749 0.64288654 5.906595e-07 -0.06531984 -0.06531984 -0.06531984 + 5150 0.515 0.64305671 0.64305564 6.0516793e-07 -0.065406851 -0.065406851 -0.065406851 + 5160 0.516 0.64322555 0.64322436 6.0790921e-07 -0.065493689 -0.065493689 -0.065493689 + 5170 0.517 0.64339401 0.6433927 5.9883899e-07 -0.065580355 -0.065580355 -0.065580355 + 5180 0.518 0.64356209 0.64356067 5.7813833e-07 -0.065666848 -0.065666848 -0.065666848 + 5190 0.519 0.64372979 0.64372826 5.4621027e-07 -0.065753168 -0.065753168 -0.065753168 + 5200 0.52 0.64389711 0.64389547 5.036722e-07 -0.065839316 -0.065839316 -0.065839316 + 5210 0.521 0.64406405 0.64406231 4.5134419e-07 -0.065925292 -0.065925292 -0.065925292 + 5220 0.522 0.6442306 0.64422878 3.9023331e-07 -0.066011096 -0.066011096 -0.066011096 + 5230 0.523 0.64439677 0.64439488 3.2151444e-07 -0.066096729 -0.066096729 -0.066096729 + 5240 0.524 0.64456256 0.64456061 2.4650783e-07 -0.066182189 -0.066182189 -0.066182189 + 5250 0.525 0.64472797 0.64472597 1.6665388e-07 -0.066267477 -0.066267477 -0.066267477 + 5260 0.526 0.64489299 0.64489096 8.3485522e-08 -0.066352594 -0.066352594 -0.066352594 + 5270 0.527 0.64505763 0.64505559 -1.4011251e-09 -0.06643754 -0.06643754 -0.06643754 + 5280 0.528 0.64522188 0.64521986 -8.6377351e-08 -0.066522314 -0.066522314 -0.066522314 + 5290 0.529 0.64538576 0.64538376 -1.6981312e-07 -0.066606917 -0.066606917 -0.066606917 + 5300 0.53 0.64554925 0.64554729 -2.5010835e-07 -0.066691349 -0.066691349 -0.066691349 + 5310 0.531 0.64571237 0.64571046 -3.2572373e-07 -0.066775611 -0.066775611 -0.066775611 + 5320 0.532 0.6458751 0.64587326 -3.9521022e-07 -0.066859701 -0.066859701 -0.066859701 + 5330 0.533 0.64603746 0.6460357 -4.5723704e-07 -0.066943621 -0.066943621 -0.066943621 + 5340 0.534 0.64619944 0.64619778 -5.1061726e-07 -0.06702737 -0.06702737 -0.06702737 + 5350 0.535 0.64636105 0.64635948 -5.5433068e-07 -0.067110948 -0.067110948 -0.067110948 + 5360 0.536 0.64652228 0.64652083 -5.8754354e-07 -0.067194357 -0.067194357 -0.067194357 + 5370 0.537 0.64668314 0.6466818 -6.0962458e-07 -0.067277595 -0.067277595 -0.067277595 + 5380 0.538 0.64684363 0.64684241 -6.2015733e-07 -0.067360664 -0.067360664 -0.067360664 + 5390 0.539 0.64700376 0.64700266 -6.1894809e-07 -0.067443562 -0.067443562 -0.067443562 + 5400 0.54 0.64716351 0.64716253 -6.0602979e-07 -0.067526291 -0.067526291 -0.067526291 + 5410 0.541 0.6473229 0.64732204 -5.8166135e-07 -0.06760885 -0.06760885 -0.06760885 + 5420 0.542 0.64748193 0.64748117 -5.4632271e-07 -0.06769124 -0.06769124 -0.06769124 + 5430 0.543 0.6476406 0.64763994 -5.0070563e-07 -0.06777346 -0.06777346 -0.06777346 + 5440 0.544 0.6477989 0.64779833 -4.4570029e-07 -0.067855512 -0.067855512 -0.067855512 + 5450 0.545 0.64795685 0.64795636 -3.8237815e-07 -0.067937394 -0.067937394 -0.067937394 + 5460 0.546 0.64811444 0.64811401 -3.119712e-07 -0.068019108 -0.068019108 -0.068019108 + 5470 0.547 0.64827167 0.6482713 -2.3584813e-07 -0.068100653 -0.068100653 -0.068100653 + 5480 0.548 0.64842855 0.64842821 -1.5548783e-07 -0.068182029 -0.068182029 -0.068182029 + 5490 0.549 0.64858507 0.64858475 -7.2450737e-08 -0.068263237 -0.068263237 -0.068263237 + 5500 0.55 0.64874124 0.64874092 1.1651408e-08 -0.068344276 -0.068344276 -0.068344276 + 5510 0.551 0.64889706 0.64889673 9.5186848e-08 -0.068425148 -0.068425148 -0.068425148 + 5520 0.552 0.64905252 0.64905216 1.7653547e-07 -0.068505851 -0.068505851 -0.068505851 + 5530 0.553 0.64920763 0.64920722 2.5412026e-07 -0.068586387 -0.068586387 -0.068586387 + 5540 0.554 0.64936239 0.64936192 3.2643798e-07 -0.068666755 -0.068666755 -0.068666755 + 5550 0.555 0.64951679 0.64951625 3.9208836e-07 -0.068746955 -0.068746955 -0.068746955 + 5560 0.556 0.64967085 0.64967022 4.4980134e-07 -0.068826988 -0.068826988 -0.068826988 + 5570 0.557 0.64982455 0.64982382 4.984618e-07 -0.068906854 -0.068906854 -0.068906854 + 5580 0.558 0.64997789 0.64997706 5.3713127e-07 -0.068986553 -0.068986553 -0.068986553 + 5590 0.559 0.65013089 0.65012995 5.6506622e-07 -0.069066085 -0.069066085 -0.069066085 + 5600 0.56 0.65028353 0.65028247 5.8173253e-07 -0.069145451 -0.069145451 -0.069145451 + 5610 0.561 0.65043581 0.65043463 5.8681591e-07 -0.069224649 -0.069224649 -0.069224649 + 5620 0.562 0.65058774 0.65058645 5.8022805e-07 -0.069303682 -0.069303682 -0.069303682 + 5630 0.563 0.65073931 0.6507379 5.6210832e-07 -0.069382548 -0.069382548 -0.069382548 + 5640 0.564 0.65089053 0.65088901 5.3282107e-07 -0.069461248 -0.069461248 -0.069461248 + 5650 0.565 0.65104139 0.65103976 4.9294848e-07 -0.069539782 -0.069539782 -0.069539782 + 5660 0.566 0.65119189 0.65119017 4.4327921e-07 -0.06961815 -0.06961815 -0.06961815 + 5670 0.567 0.65134203 0.65134023 3.8479296e-07 -0.069696352 -0.069696352 -0.069696352 + 5680 0.568 0.65149182 0.65148994 3.186413e-07 -0.06977439 -0.06977439 -0.06977439 + 5690 0.569 0.65164124 0.65163931 2.4612515e-07 -0.069852262 -0.069852262 -0.069852262 + 5700 0.57 0.65179031 0.65178833 1.6866929e-07 -0.069929968 -0.069929968 -0.069929968 + 5710 0.571 0.65193902 0.65193702 8.7794446e-08 -0.07000751 -0.07000751 -0.07000751 + 5720 0.572 0.65208737 0.65208536 5.0875238e-09 -0.070084887 -0.070084887 -0.070084887 + 5730 0.573 0.65223537 0.65223336 -7.7829543e-08 -0.0701621 -0.0701621 -0.0701621 + 5740 0.574 0.65238301 0.65238102 -1.5933158e-07 -0.070239148 -0.070239148 -0.070239148 + 5750 0.575 0.65253029 0.65252834 -2.3782204e-07 -0.070316032 -0.070316032 -0.070316032 + 5760 0.576 0.65267721 0.65267532 -3.1176438e-07 -0.070392751 -0.070392751 -0.070392751 + 5770 0.577 0.65282379 0.65282196 -3.7971217e-07 -0.070469307 -0.070469307 -0.070469307 + 5780 0.578 0.65297001 0.65296826 -4.4033753e-07 -0.070545699 -0.070545699 -0.070545699 + 5790 0.579 0.65311588 0.65311422 -4.9245722e-07 -0.070621928 -0.070621928 -0.070621928 + 5800 0.58 0.65326139 0.65325983 -5.3505586e-07 -0.070697993 -0.070697993 -0.070697993 + 5810 0.581 0.65340657 0.65340511 -5.6730589e-07 -0.070773895 -0.070773895 -0.070773895 + 5820 0.582 0.65355139 0.65355005 -5.8858382e-07 -0.070849633 -0.070849633 -0.070849633 + 5830 0.583 0.65369587 0.65369464 -5.9848249e-07 -0.070925209 -0.070925209 -0.070925209 + 5840 0.584 0.65384 0.65383889 -5.9681904e-07 -0.071000623 -0.071000623 -0.071000623 + 5850 0.585 0.6539838 0.6539828 -5.8363849e-07 -0.071075873 -0.071075873 -0.071075873 + 5860 0.586 0.65412725 0.65412637 -5.5921279e-07 -0.071150962 -0.071150962 -0.071150962 + 5870 0.587 0.65427036 0.65426959 -5.2403544e-07 -0.071225888 -0.071225888 -0.071225888 + 5880 0.588 0.65441314 0.65441246 -4.7881168e-07 -0.071300652 -0.071300652 -0.071300652 + 5890 0.589 0.65455559 0.65455499 -4.2444456e-07 -0.071375254 -0.071375254 -0.071375254 + 5900 0.59 0.6546977 0.65469718 -3.6201704e-07 -0.071449695 -0.071449695 -0.071449695 + 5910 0.591 0.65483947 0.65483902 -2.9277058e-07 -0.071523975 -0.071523975 -0.071523975 + 5920 0.592 0.65498092 0.65498051 -2.1808055e-07 -0.071598093 -0.071598093 -0.071598093 + 5930 0.593 0.65512204 0.65512166 -1.39429e-07 -0.07167205 -0.07167205 -0.07167205 + 5940 0.594 0.65526282 0.65526246 -5.837535e-08 -0.071745846 -0.071745846 -0.071745846 + 5950 0.595 0.65540328 0.65540292 2.3474531e-08 -0.071819481 -0.071819481 -0.071819481 + 5960 0.596 0.65554341 0.65554303 1.045001e-07 -0.071892956 -0.071892956 -0.071892956 + 5970 0.597 0.65568321 0.6556828 1.8309825e-07 -0.071966271 -0.071966271 -0.071966271 + 5980 0.598 0.65582269 0.65582223 2.5771506e-07 -0.072039425 -0.072039425 -0.072039425 + 5990 0.599 0.65596183 0.65596132 3.2687663e-07 -0.07211242 -0.07211242 -0.07211242 + 6000 0.6 0.65610065 0.65610006 3.8921821e-07 -0.072185255 -0.072185255 -0.072185255 + 6010 0.601 0.65623915 0.65623847 4.4351131e-07 -0.07225793 -0.07225793 -0.07225793 + 6020 0.602 0.65637731 0.65637654 4.8868803e-07 -0.072330445 -0.072330445 -0.072330445 + 6030 0.603 0.65651515 0.65651427 5.2386219e-07 -0.072402802 -0.072402802 -0.072402802 + 6040 0.604 0.65665265 0.65665167 5.483469e-07 -0.072475 -0.072475 -0.072475 + 6050 0.605 0.65678983 0.65678873 5.6166814e-07 -0.072547038 -0.072547038 -0.072547038 + 6060 0.606 0.65692668 0.65692546 5.6357412e-07 -0.072618918 -0.072618918 -0.072618918 + 6070 0.607 0.6570632 0.65706187 5.5404021e-07 -0.07269064 -0.07269064 -0.07269064 + 6080 0.608 0.65719939 0.65719794 5.3326936e-07 -0.072762203 -0.072762203 -0.072762203 + 6090 0.609 0.65733524 0.65733369 5.0168797e-07 -0.072833609 -0.072833609 -0.072833609 + 6100 0.61 0.65747077 0.65746912 4.5993733e-07 -0.072904856 -0.072904856 -0.072904856 + 6110 0.611 0.65760596 0.65760422 4.0886077e-07 -0.072975946 -0.072975946 -0.072975946 + 6120 0.612 0.65774082 0.65773901 3.4948676e-07 -0.073046879 -0.073046879 -0.073046879 + 6130 0.613 0.65787535 0.65787347 2.8300837e-07 -0.073117654 -0.073117654 -0.073117654 + 6140 0.614 0.65800954 0.65800761 2.1075937e-07 -0.073188272 -0.073188272 -0.073188272 + 6150 0.615 0.6581434 0.65814143 1.341876e-07 -0.073258733 -0.073258733 -0.073258733 + 6160 0.616 0.65827693 0.65827494 5.482599e-08 -0.073329038 -0.073329038 -0.073329038 + 6170 0.617 0.65841013 0.65840813 -2.5738053e-08 -0.073399186 -0.073399186 -0.073399186 + 6180 0.618 0.65854299 0.65854101 -1.0589441e-07 -0.073469178 -0.073469178 -0.073469178 + 6190 0.619 0.65867553 0.65867357 -1.8404242e-07 -0.073539013 -0.073539013 -0.073539013 + 6200 0.62 0.65880773 0.65880582 -2.586229e-07 -0.073608693 -0.073608693 -0.073608693 + 6210 0.621 0.6589396 0.65893775 -3.2814928e-07 -0.073678217 -0.073678217 -0.073678217 + 6220 0.622 0.65907115 0.65906937 -3.9123734e-07 -0.073747586 -0.073747586 -0.073747586 + 6230 0.623 0.65920237 0.65920067 -4.4663288e-07 -0.073816799 -0.073816799 -0.073816799 + 6240 0.624 0.65933327 0.65933165 -4.9323677e-07 -0.073885858 -0.073885858 -0.073885858 + 6250 0.625 0.65946384 0.65946233 -5.3012687e-07 -0.073954761 -0.073954761 -0.073954761 + 6260 0.626 0.65959409 0.65959268 -5.565765e-07 -0.07402351 -0.07402351 -0.07402351 + 6270 0.627 0.65972402 0.65972272 -5.7206883e-07 -0.074092104 -0.074092104 -0.074092104 + 6280 0.628 0.65985363 0.65985244 -5.7630721e-07 -0.074160545 -0.074160545 -0.074160545 + 6290 0.629 0.65998292 0.65998185 -5.6922099e-07 -0.074228831 -0.074228831 -0.074228831 + 6300 0.63 0.6601119 0.66011094 -5.5096683e-07 -0.074296963 -0.074296963 -0.074296963 + 6310 0.631 0.66024056 0.66023971 -5.2192546e-07 -0.074364941 -0.074364941 -0.074364941 + 6320 0.632 0.66036891 0.66036816 -4.8269389e-07 -0.074432767 -0.074432767 -0.074432767 + 6330 0.633 0.66049695 0.66049629 -4.340733e-07 -0.074500438 -0.074500438 -0.074500438 + 6340 0.634 0.66062468 0.6606241 -3.7705289e-07 -0.074567957 -0.074567957 -0.074567957 + 6350 0.635 0.66075211 0.66075159 -3.1278979e-07 -0.074635324 -0.074635324 -0.074635324 + 6360 0.636 0.66087923 0.66087876 -2.4258579e-07 -0.074702537 -0.074702537 -0.074702537 + 6370 0.637 0.66100604 0.66100561 -1.6786098e-07 -0.074769598 -0.074769598 -0.074769598 + 6380 0.638 0.66113255 0.66113214 -9.0125159e-08 -0.074836507 -0.074836507 -0.074836507 + 6390 0.639 0.66125875 0.66125835 -1.0947326e-08 -0.074903264 -0.074903264 -0.074903264 + 6400 0.64 0.66138466 0.66138424 6.8075937e-08 -0.074969869 -0.074969869 -0.074969869 + 6410 0.641 0.66151025 0.66150982 1.4535267e-07 -0.075036323 -0.075036323 -0.075036323 + 6420 0.642 0.66163555 0.66163508 2.1932764e-07 -0.075102625 -0.075102625 -0.075102625 + 6430 0.643 0.66176055 0.66176002 2.8851367e-07 -0.075168776 -0.075168776 -0.075168776 + 6440 0.644 0.66188524 0.66188464 3.5152165e-07 -0.075234776 -0.075234776 -0.075234776 + 6450 0.645 0.66200963 0.66200895 4.0708847e-07 -0.075300626 -0.075300626 -0.075300626 + 6460 0.646 0.66213372 0.66213295 4.5410251e-07 -0.075366325 -0.075366325 -0.075366325 + 6470 0.647 0.66225751 0.66225664 4.9162594e-07 -0.075431874 -0.075431874 -0.075431874 + 6480 0.648 0.66238099 0.66238002 5.1891364e-07 -0.075497273 -0.075497273 -0.075497273 + 6490 0.649 0.66250417 0.66250309 5.3542807e-07 -0.075562521 -0.075562521 -0.075562521 + 6500 0.65 0.66262704 0.66262585 5.4085008e-07 -0.075627621 -0.075627621 -0.075627621 + 6510 0.651 0.66274961 0.66274831 5.3508518e-07 -0.07569257 -0.07569257 -0.07569257 + 6520 0.652 0.66287188 0.66287047 5.1826535e-07 -0.075757371 -0.075757371 -0.075757371 + 6530 0.653 0.66299384 0.66299232 4.9074618e-07 -0.075822022 -0.075822022 -0.075822022 + 6540 0.654 0.66311549 0.66311388 4.5309958e-07 -0.075886525 -0.075886525 -0.075886525 + 6550 0.655 0.66323684 0.66323514 4.0610197e-07 -0.075950879 -0.075950879 -0.075950879 + 6560 0.656 0.66335788 0.6633561 3.5071851e-07 -0.076015085 -0.076015085 -0.076015085 + 6570 0.657 0.66347861 0.66347677 2.8808331e-07 -0.076079143 -0.076079143 -0.076079143 + 6580 0.658 0.66359904 0.66359714 2.1947637e-07 -0.076143053 -0.076143053 -0.076143053 + 6590 0.659 0.66371916 0.66371722 1.462975e-07 -0.076206815 -0.076206815 -0.076206815 + 6600 0.66 0.66383897 0.66383701 7.003782e-08 -0.07627043 -0.07627043 -0.07627043 + 6610 0.661 0.66395847 0.6639565 -7.7505971e-09 -0.076333897 -0.076333897 -0.076333897 + 6620 0.662 0.66407767 0.66407571 -8.5486262e-08 -0.076397218 -0.076397218 -0.076397218 + 6630 0.663 0.66419657 0.66419463 -1.6159044e-07 -0.076460391 -0.076460391 -0.076460391 + 6640 0.664 0.66431515 0.66431325 -2.3451925e-07 -0.076523418 -0.076523418 -0.076523418 + 6650 0.665 0.66443344 0.66443159 -3.02795e-07 -0.076586299 -0.076586299 -0.076586299 + 6660 0.666 0.66455142 0.66454964 -3.6503624e-07 -0.076649033 -0.076649033 -0.076649033 + 6670 0.667 0.6646691 0.66466739 -4.1998576e-07 -0.076711622 -0.076711622 -0.076711622 + 6680 0.668 0.66478648 0.66478486 -4.6653612e-07 -0.076774064 -0.076774064 -0.076774064 + 6690 0.669 0.66490357 0.66490204 -5.0375208e-07 -0.076836362 -0.076836362 -0.076836362 + 6700 0.67 0.66502035 0.66501893 -5.308895e-07 -0.076898514 -0.076898514 -0.076898514 + 6710 0.671 0.66513684 0.66513553 -5.4741039e-07 -0.07696052 -0.07696052 -0.07696052 + 6720 0.672 0.66525304 0.66525183 -5.5299372e-07 -0.077022383 -0.077022383 -0.077022383 + 6730 0.673 0.66536894 0.66536785 -5.4754176e-07 -0.0770841 -0.0770841 -0.0770841 + 6740 0.674 0.66548456 0.66548357 -5.3118195e-07 -0.077145673 -0.077145673 -0.077145673 + 6750 0.675 0.66559988 0.66559899 -5.042641e-07 -0.077207102 -0.077207102 -0.077207102 + 6760 0.676 0.66571492 0.66571413 -4.6735306e-07 -0.077268387 -0.077268387 -0.077268387 + 6770 0.677 0.66582968 0.66582897 -4.2121706e-07 -0.077329528 -0.077329528 -0.077329528 + 6780 0.678 0.66594414 0.66594352 -3.6681181e-07 -0.077390526 -0.077390526 -0.077390526 + 6790 0.679 0.66605833 0.66605777 -3.0526088e-07 -0.077451381 -0.077451381 -0.077451381 + 6800 0.68 0.66617224 0.66617172 -2.3783252e-07 -0.077512092 -0.077512092 -0.077512092 + 6810 0.681 0.66628586 0.66628539 -1.6591369e-07 -0.077572661 -0.077572661 -0.077572661 + 6820 0.682 0.66639921 0.66639875 -9.0981551e-08 -0.077633087 -0.077633087 -0.077633087 + 6830 0.683 0.66651227 0.66651183 -1.4573167e-08 -0.07769337 -0.07769337 -0.07769337 + 6840 0.684 0.66662506 0.66662461 6.1745978e-08 -0.077753512 -0.077753512 -0.077753512 + 6850 0.685 0.66673757 0.6667371 1.3641408e-07 -0.077813512 -0.077813512 -0.077813512 + 6860 0.686 0.66684981 0.66684929 2.0790497e-07 -0.07787337 -0.07787337 -0.07787337 + 6870 0.687 0.66696177 0.6669612 2.747594e-07 -0.077933086 -0.077933086 -0.077933086 + 6880 0.688 0.66707345 0.66707281 3.3561482e-07 -0.077992661 -0.077992661 -0.077992661 + 6890 0.689 0.66718485 0.66718414 3.8923331e-07 -0.078052095 -0.078052095 -0.078052095 + 6900 0.69 0.66729597 0.66729518 4.3452679e-07 -0.078111389 -0.078111389 -0.078111389 + 6910 0.691 0.66740682 0.66740593 4.7057924e-07 -0.078170542 -0.078170542 -0.078170542 + 6920 0.692 0.66751739 0.6675164 4.9666535e-07 -0.078229554 -0.078229554 -0.078229554 + 6930 0.693 0.66762768 0.66762659 5.1226525e-07 -0.078288426 -0.078288426 -0.078288426 + 6940 0.694 0.6677377 0.66773649 5.1707495e-07 -0.078347159 -0.078347159 -0.078347159 + 6950 0.695 0.66784743 0.66784612 5.1101247e-07 -0.078405752 -0.078405752 -0.078405752 + 6960 0.696 0.66795688 0.66795547 4.9421925e-07 -0.078464205 -0.078464205 -0.078464205 + 6970 0.697 0.66806605 0.66806454 4.670571e-07 -0.078522519 -0.078522519 -0.078522519 + 6980 0.698 0.66817494 0.66817333 4.301005e-07 -0.078580695 -0.078580695 -0.078580695 + 6990 0.699 0.66828355 0.66828186 3.8412465e-07 -0.078638731 -0.078638731 -0.078638731 + 7000 0.7 0.66839188 0.66839011 3.3008929e-07 -0.078696629 -0.078696629 -0.078696629 + 7010 0.701 0.66849993 0.66849809 2.6911881e-07 -0.078754389 -0.078754389 -0.078754389 + 7020 0.702 0.66860769 0.66860581 2.0247889e-07 -0.078812011 -0.078812011 -0.078812011 + 7030 0.703 0.66871517 0.66871325 1.3155039e-07 -0.078869494 -0.078869494 -0.078869494 + 7040 0.704 0.66882237 0.66882043 5.7800711e-08 -0.078926841 -0.078926841 -0.078926841 + 7050 0.705 0.66892929 0.66892734 -1.724648e-08 -0.07898405 -0.07898405 -0.07898405 + 7060 0.706 0.66903593 0.66903399 -9.2042729e-08 -0.079041121 -0.079041121 -0.079041121 + 7070 0.707 0.66914228 0.66914037 -1.6504674e-07 -0.079098056 -0.079098056 -0.079098056 + 7080 0.708 0.66924836 0.66924649 -2.3475617e-07 -0.079154854 -0.079154854 -0.079154854 + 7090 0.709 0.66935416 0.66935234 -2.9973858e-07 -0.079211516 -0.079211516 -0.079211516 + 7100 0.71 0.66945968 0.66945793 -3.5866093e-07 -0.079268042 -0.079268042 -0.079268042 + 7110 0.711 0.66956493 0.66956325 -4.1031703e-07 -0.079324431 -0.079324431 -0.079324431 + 7120 0.712 0.6696699 0.66966831 -4.5365227e-07 -0.079380685 -0.079380685 -0.079380685 + 7130 0.713 0.6697746 0.6697731 -4.877853e-07 -0.079436803 -0.079436803 -0.079436803 + 7140 0.714 0.66987902 0.66987762 -5.1202608e-07 -0.079492786 -0.079492786 -0.079492786 + 7150 0.715 0.66998318 0.66998188 -5.2588991e-07 -0.079548634 -0.079548634 -0.079548634 + 7160 0.716 0.67008707 0.67008587 -5.2910725e-07 -0.079604347 -0.079604347 -0.079604347 + 7170 0.717 0.67019069 0.6701896 -5.2162911e-07 -0.079659926 -0.079659926 -0.079659926 + 7180 0.718 0.67029404 0.67029305 -5.0362782e-07 -0.07971537 -0.07971537 -0.07971537 + 7190 0.719 0.67039713 0.67039624 -4.7549322e-07 -0.07977068 -0.07977068 -0.07977068 + 7200 0.72 0.67049996 0.67049916 -4.3782437e-07 -0.079825856 -0.079825856 -0.079825856 + 7210 0.721 0.67060253 0.67060181 -3.9141694e-07 -0.079880898 -0.079880898 -0.079880898 + 7220 0.722 0.67070484 0.67070419 -3.3724651e-07 -0.079935807 -0.079935807 -0.079935807 + 7230 0.723 0.67080689 0.6708063 -2.7644818e-07 -0.079990583 -0.079990583 -0.079990583 + 7240 0.724 0.67090868 0.67090814 -2.1029284e-07 -0.080045226 -0.080045226 -0.080045226 + 7250 0.725 0.67101022 0.67100972 -1.4016069e-07 -0.080099736 -0.080099736 -0.080099736 + 7260 0.726 0.67111151 0.67111102 -6.7512524e-08 -0.080154113 -0.080154113 -0.080154113 + 7270 0.727 0.67121254 0.67121205 6.1407051e-09 -0.080208359 -0.080208359 -0.080208359 + 7280 0.728 0.67131331 0.67131281 7.9269275e-08 -0.080262472 -0.080262472 -0.080262472 + 7290 0.729 0.67141384 0.67141331 1.5035647e-07 -0.080316453 -0.080316453 -0.080316453 + 7300 0.73 0.67151411 0.67151354 2.1793008e-07 -0.080370303 -0.080370303 -0.080370303 + 7310 0.731 0.67161412 0.6716135 2.805929e-07 -0.080424022 -0.080424022 -0.080424022 + 7320 0.732 0.67171389 0.6717132 3.370517e-07 -0.080477609 -0.080477609 -0.080477609 + 7330 0.733 0.6718134 0.67181263 3.8614399e-07 -0.080531065 -0.080531065 -0.080531065 + 7340 0.734 0.67191266 0.67191181 4.2686203e-07 -0.080584391 -0.080584391 -0.080584391 + 7350 0.735 0.67201166 0.67201072 4.5837364e-07 -0.080637587 -0.080637587 -0.080637587 + 7360 0.736 0.67211041 0.67210937 4.8003926e-07 -0.080690652 -0.080690652 -0.080690652 + 7370 0.737 0.67220891 0.67220776 4.9142511e-07 -0.080743587 -0.080743587 -0.080743587 + 7380 0.738 0.67230715 0.6723059 4.9231193e-07 -0.080796393 -0.080796393 -0.080796393 + 7390 0.739 0.67240514 0.67240378 4.8269932e-07 -0.080849069 -0.080849069 -0.080849069 + 7400 0.74 0.67250287 0.67250142 4.6280552e-07 -0.080901616 -0.080901616 -0.080901616 + 7410 0.741 0.67260034 0.67259879 4.3306257e-07 -0.080954034 -0.080954034 -0.080954034 + 7420 0.742 0.67269756 0.67269592 3.941071e-07 -0.081006323 -0.081006323 -0.081006323 + 7430 0.743 0.67279451 0.6727928 3.467668e-07 -0.081058483 -0.081058483 -0.081058483 + 7440 0.744 0.67289122 0.67288944 2.9204295e-07 -0.081110515 -0.081110515 -0.081110515 + 7450 0.745 0.67298766 0.67298583 2.3108931e-07 -0.08116242 -0.08116242 -0.08116242 + 7460 0.746 0.67308384 0.67308197 1.6518793e-07 -0.081214196 -0.081214196 -0.081214196 + 7470 0.747 0.67317977 0.67317787 9.572218e-08 -0.081265845 -0.081265845 -0.081265845 + 7480 0.748 0.67327544 0.67327352 2.4147794e-08 -0.081317366 -0.081317366 -0.081317366 + 7490 0.749 0.67337086 0.67336894 -4.8037625e-08 -0.08136876 -0.08136876 -0.08136876 + 7500 0.75 0.67346601 0.67346411 -1.1932593e-07 -0.081420027 -0.081420027 -0.081420027 + 7510 0.751 0.67356092 0.67355904 -1.8822994e-07 -0.081471168 -0.081471168 -0.081471168 + 7520 0.752 0.67365556 0.67365373 -2.5331452e-07 -0.081522182 -0.081522182 -0.081522182 + 7530 0.753 0.67374996 0.67374818 -3.1322649e-07 -0.08157307 -0.08157307 -0.08157307 + 7540 0.754 0.6738441 0.67384239 -3.6672281e-07 -0.081623832 -0.081623832 -0.081623832 + 7550 0.755 0.67393798 0.67393636 -4.1269647e-07 -0.081674468 -0.081674468 -0.081674468 + 7560 0.756 0.67403162 0.67403008 -4.5019948e-07 -0.081724979 -0.081724979 -0.081724979 + 7570 0.757 0.67412501 0.67412356 -4.7846249e-07 -0.081775364 -0.081775364 -0.081775364 + 7580 0.758 0.67421815 0.6742168 -4.9691069e-07 -0.081825624 -0.081825624 -0.081825624 + 7590 0.759 0.67431105 0.6743098 -5.051756e-07 -0.08187576 -0.08187576 -0.08187576 + 7600 0.76 0.67440371 0.67440255 -5.0310252e-07 -0.081925771 -0.081925771 -0.081925771 + 7610 0.761 0.67449612 0.67449506 -4.9075352e-07 -0.081975657 -0.081975657 -0.081975657 + 7620 0.762 0.67458829 0.67458733 -4.6840587e-07 -0.08202542 -0.08202542 -0.08202542 + 7630 0.763 0.67468022 0.67467935 -4.3654593e-07 -0.082075059 -0.082075059 -0.082075059 + 7640 0.764 0.67477191 0.67477113 -3.9585872e-07 -0.082124574 -0.082124574 -0.082124574 + 7650 0.765 0.67486337 0.67486266 -3.4721328e-07 -0.082173965 -0.082173965 -0.082173965 + 7660 0.766 0.67495459 0.67495394 -2.9164422e-07 -0.082223234 -0.082223234 -0.082223234 + 7670 0.767 0.67504557 0.67504498 -2.303298e-07 -0.082272379 -0.082272379 -0.082272379 + 7680 0.768 0.67513633 0.67513577 -1.6456699e-07 -0.082321402 -0.082321402 -0.082321402 + 7690 0.769 0.67522685 0.67522631 -9.574414e-08 -0.082370302 -0.082370302 -0.082370302 + 7700 0.77 0.67531714 0.67531661 -2.5311649e-08 -0.08241908 -0.08241908 -0.08241908 + 7710 0.771 0.6754072 0.67540667 4.5248535e-08 -0.082467737 -0.082467737 -0.082467737 + 7720 0.772 0.67549703 0.67549648 1.1445412e-07 -0.082516271 -0.082516271 -0.082516271 + 7730 0.773 0.67558663 0.67558605 1.808536e-07 -0.082564684 -0.082564684 -0.082564684 + 7740 0.774 0.67567601 0.67567537 2.4305674e-07 -0.082612975 -0.082612975 -0.082612975 + 7750 0.775 0.67576515 0.67576445 2.9976375e-07 -0.082661145 -0.082661145 -0.082661145 + 7760 0.776 0.67585406 0.67585329 3.4979244e-07 -0.082709195 -0.082709195 -0.082709195 + 7770 0.777 0.67594274 0.6759419 3.92103e-07 -0.082757124 -0.082757124 -0.082757124 + 7780 0.778 0.67603119 0.67603026 4.2581967e-07 -0.082804933 -0.082804933 -0.082804933 + 7790 0.779 0.67611941 0.67611839 4.5024891e-07 -0.082852621 -0.082852621 -0.082852621 + 7800 0.78 0.6762074 0.67620628 4.6489385e-07 -0.08290019 -0.08290019 -0.08290019 + 7810 0.781 0.67629516 0.67629394 4.694644e-07 -0.082947638 -0.082947638 -0.082947638 + 7820 0.782 0.67638268 0.67638136 4.6388312e-07 -0.082994968 -0.082994968 -0.082994968 + 7830 0.783 0.67646997 0.67646856 4.4828658e-07 -0.083042178 -0.083042178 -0.083042178 + 7840 0.784 0.67655703 0.67655553 4.2302214e-07 -0.083089269 -0.083089269 -0.083089269 + 7850 0.785 0.67664386 0.67664227 3.886404e-07 -0.083136242 -0.083136242 -0.083136242 + 7860 0.786 0.67673045 0.67672878 3.4588328e-07 -0.083183096 -0.083183096 -0.083183096 + 7870 0.787 0.67681681 0.67681507 2.9566809e-07 -0.083229832 -0.083229832 -0.083229832 + 7880 0.788 0.67690293 0.67690114 2.3906798e-07 -0.083276449 -0.083276449 -0.083276449 + 7890 0.789 0.67698882 0.67698698 1.7728904e-07 -0.083322949 -0.083322949 -0.083322949 + 7900 0.79 0.67707447 0.6770726 1.1164468e-07 -0.083369331 -0.083369331 -0.083369331 + 7910 0.791 0.67715989 0.677158 4.3527757e-08 -0.083415596 -0.083415596 -0.083415596 + 7920 0.792 0.67724508 0.67724318 -2.5618985e-08 -0.083461744 -0.083461744 -0.083461744 + 7930 0.793 0.67733003 0.67732815 -9.4333425e-08 -0.083507775 -0.083507775 -0.083507775 + 7940 0.794 0.67741475 0.67741289 -1.61165e-07 -0.083553689 -0.083553689 -0.083553689 + 7950 0.795 0.67749923 0.67749741 -2.2470534e-07 -0.083599487 -0.083599487 -0.083599487 + 7960 0.796 0.67758349 0.67758172 -2.83618e-07 -0.083645169 -0.083645169 -0.083645169 + 7970 0.797 0.67766751 0.67766581 -3.3666656e-07 -0.083690735 -0.083690735 -0.083690735 + 7980 0.798 0.67775131 0.67774967 -3.8274072e-07 -0.083736185 -0.083736185 -0.083736185 + 7990 0.799 0.67783488 0.67783332 -4.2087952e-07 -0.083781519 -0.083781519 -0.083781519 + 8000 0.8 0.67791822 0.67791675 -4.5029151e-07 -0.083826738 -0.083826738 -0.083826738 + 8010 0.801 0.67800134 0.67799996 -4.7037125e-07 -0.083871843 -0.083871843 -0.083871843 + 8020 0.802 0.67808423 0.67808295 -4.8071186e-07 -0.083916832 -0.083916832 -0.083916832 + 8030 0.803 0.67816691 0.67816572 -4.8111332e-07 -0.083961707 -0.083961707 -0.083961707 + 8040 0.804 0.67824936 0.67824827 -4.7158646e-07 -0.084006467 -0.084006467 -0.084006467 + 8050 0.805 0.67833159 0.6783306 -4.5235237e-07 -0.084051114 -0.084051114 -0.084051114 + 8060 0.806 0.67841361 0.6784127 -4.2383744e-07 -0.084095646 -0.084095646 -0.084095646 + 8070 0.807 0.67849541 0.67849458 -3.8666401e-07 -0.084140065 -0.084140065 -0.084140065 + 8080 0.808 0.67857699 0.67857624 -3.416369e-07 -0.08418437 -0.08418437 -0.08418437 + 8090 0.809 0.67865837 0.67865767 -2.8972605e-07 -0.084228563 -0.084228563 -0.084228563 + 8100 0.81 0.67873953 0.67873888 -2.3204574e-07 -0.084272642 -0.084272642 -0.084272642 + 8110 0.811 0.67882047 0.67881987 -1.6983071e-07 -0.084316609 -0.084316609 -0.084316609 + 8120 0.812 0.67890121 0.67890063 -1.0440976e-07 -0.084360463 -0.084360463 -0.084360463 + 8130 0.813 0.67898174 0.67898117 -3.7177474e-08 -0.084404204 -0.084404204 -0.084404204 + 8140 0.814 0.67906206 0.67906149 3.043557e-08 -0.084447834 -0.084447834 -0.084447834 + 8150 0.815 0.67914218 0.67914159 9.6993173e-08 -0.084491352 -0.084491352 -0.084491352 + 8160 0.816 0.67922208 0.67922146 1.6108406e-07 -0.084534759 -0.084534759 -0.084534759 + 8170 0.817 0.67930178 0.67930112 2.2135179e-07 -0.084578054 -0.084578054 -0.084578054 + 8180 0.818 0.67938127 0.67938055 2.7652357e-07 -0.084621237 -0.084621237 -0.084621237 + 8190 0.819 0.67946055 0.67945976 3.2543709e-07 -0.08466431 -0.08466431 -0.08466431 + 8200 0.82 0.67953962 0.67953876 3.6706513e-07 -0.084707273 -0.084707273 -0.084707273 + 8210 0.821 0.67961848 0.67961754 4.0053718e-07 -0.084750125 -0.084750125 -0.084750125 + 8220 0.822 0.67969714 0.67969611 4.2515771e-07 -0.084792866 -0.084792866 -0.084792866 + 8230 0.823 0.67977558 0.67977446 4.4042071e-07 -0.084835498 -0.084835498 -0.084835498 + 8240 0.824 0.67985382 0.67985261 4.4602016e-07 -0.08487802 -0.08487802 -0.08487802 + 8250 0.825 0.67993184 0.67993054 4.4185622e-07 -0.084920432 -0.084920432 -0.084920432 + 8260 0.826 0.68000966 0.68000826 4.2803707e-07 -0.084962736 -0.084962736 -0.084962736 + 8270 0.827 0.68008726 0.68008577 4.0487627e-07 -0.08500493 -0.08500493 -0.08500493 + 8280 0.828 0.68016465 0.68016308 3.7288575e-07 -0.085047015 -0.085047015 -0.085047015 + 8290 0.829 0.68024183 0.68024019 3.327646e-07 -0.085088991 -0.085088991 -0.085088991 + 8300 0.83 0.6803188 0.68031709 2.8538389e-07 -0.08513086 -0.08513086 -0.08513086 + 8310 0.831 0.68039556 0.68039379 2.3176784e-07 -0.08517262 -0.08517262 -0.08517262 + 8320 0.832 0.6804721 0.68047028 1.7307173e-07 -0.085214272 -0.085214272 -0.085214272 + 8330 0.833 0.68054843 0.68054658 1.1055705e-07 -0.085255816 -0.085255816 -0.085255816 + 8340 0.834 0.68062454 0.68062268 4.5564469e-08 -0.085297253 -0.085297253 -0.085297253 + 8350 0.835 0.68070045 0.68069858 -2.0514929e-08 -0.085338583 -0.085338583 -0.085338583 + 8360 0.836 0.68077614 0.68077428 -8.6269392e-08 -0.085379805 -0.085379805 -0.085379805 + 8370 0.837 0.68085162 0.68084978 -1.5029666e-07 -0.085420921 -0.085420921 -0.085420921 + 8380 0.838 0.68092689 0.68092509 -2.1123389e-07 -0.08546193 -0.08546193 -0.08546193 + 8390 0.839 0.68100195 0.6810002 -2.6778667e-07 -0.085502833 -0.085502833 -0.085502833 + 8400 0.84 0.6810768 0.68107511 -3.1875659e-07 -0.08554363 -0.08554363 -0.08554363 + 8410 0.841 0.68115145 0.68114982 -3.6306666e-07 -0.085584321 -0.085584321 -0.085584321 + 8420 0.842 0.68122589 0.68122434 -3.9978412e-07 -0.085624906 -0.085624906 -0.085624906 + 8430 0.843 0.68130012 0.68129865 -4.2814015e-07 -0.085665386 -0.085665386 -0.085665386 + 8440 0.844 0.68137415 0.68137277 -4.4754604e-07 -0.08570576 -0.08570576 -0.08570576 + 8450 0.845 0.68144798 0.68144669 -4.5760548e-07 -0.08574603 -0.08574603 -0.08574603 + 8460 0.846 0.6815216 0.68152041 -4.5812272e-07 -0.085786195 -0.085786195 -0.085786195 + 8470 0.847 0.68159503 0.68159393 -4.4910642e-07 -0.085826255 -0.085826255 -0.085826255 + 8480 0.848 0.68166826 0.68166725 -4.3076917e-07 -0.08586621 -0.08586621 -0.08586621 + 8490 0.849 0.6817413 0.68174037 -4.0352254e-07 -0.085906062 -0.085906062 -0.085906062 + 8500 0.85 0.68181413 0.68181328 -3.6796802e-07 -0.08594581 -0.08594581 -0.08594581 + 8510 0.851 0.68188678 0.681886 -3.2488376e-07 -0.085985454 -0.085985454 -0.085985454 + 8520 0.852 0.68195923 0.68195851 -2.7520768e-07 -0.086024995 -0.086024995 -0.086024995 + 8530 0.853 0.68203149 0.68203082 -2.2001708e-07 -0.086064432 -0.086064432 -0.086064432 + 8540 0.854 0.68210356 0.68210292 -1.6050534e-07 -0.086103767 -0.086103767 -0.086103767 + 8550 0.855 0.68217544 0.68217483 -9.7956193e-08 -0.086142998 -0.086142998 -0.086142998 + 8560 0.856 0.68224714 0.68224653 -3.3716011e-08 -0.086182128 -0.086182128 -0.086182128 + 8570 0.857 0.68231864 0.68231803 3.0835115e-08 -0.086221154 -0.086221154 -0.086221154 + 8580 0.858 0.68238996 0.68238933 9.4313031e-08 -0.086260079 -0.086260079 -0.086260079 + 8590 0.859 0.68246108 0.68246043 1.553592e-07 -0.086298902 -0.086298902 -0.086298902 + 8600 0.86 0.68253203 0.68253133 2.1266981e-07 -0.086337623 -0.086337623 -0.086337623 + 8610 0.861 0.68260278 0.68260203 2.6502363e-07 -0.086376243 -0.086376243 -0.086376243 + 8620 0.862 0.68267334 0.68267253 3.1130807e-07 -0.086414761 -0.086414761 -0.086414761 + 8630 0.863 0.68274372 0.68274284 3.505429e-07 -0.086453179 -0.086453179 -0.086453179 + 8640 0.864 0.68281391 0.68281295 3.8190104e-07 -0.086491495 -0.086491495 -0.086491495 + 8650 0.865 0.68288391 0.68288286 4.0472606e-07 -0.086529711 -0.086529711 -0.086529711 + 8660 0.866 0.68295373 0.68295259 4.1854599e-07 -0.086567827 -0.086567827 -0.086567827 + 8670 0.867 0.68302335 0.68302212 4.2308313e-07 -0.086605843 -0.086605843 -0.086605843 + 8680 0.868 0.68309278 0.68309146 4.1825971e-07 -0.086643758 -0.086643758 -0.086643758 + 8690 0.869 0.68316202 0.68316062 4.0419917e-07 -0.086681574 -0.086681574 -0.086681574 + 8700 0.87 0.68323107 0.68322958 3.8122323e-07 -0.086719291 -0.086719291 -0.086719291 + 8710 0.871 0.68329993 0.68329837 3.4984454e-07 -0.086756908 -0.086756908 -0.086756908 + 8720 0.872 0.6833686 0.68336696 3.1075544e-07 -0.086794427 -0.086794427 -0.086794427 + 8730 0.873 0.68343708 0.68343538 2.6481266e-07 -0.086831846 -0.086831846 -0.086831846 + 8740 0.874 0.68350536 0.68350361 2.1301869e-07 -0.086869167 -0.086869167 -0.086869167 + 8750 0.875 0.68357345 0.68357166 1.5649988e-07 -0.086906389 -0.086906389 -0.086906389 + 8760 0.876 0.68364135 0.68363953 9.6482097e-08 -0.086943514 -0.086943514 -0.086943514 + 8770 0.877 0.68370906 0.68370722 3.4264059e-08 -0.08698054 -0.08698054 -0.08698054 + 8780 0.878 0.68377658 0.68377474 -2.8810669e-08 -0.087017469 -0.087017469 -0.087017469 + 8790 0.879 0.6838439 0.68384207 -9.1382705e-08 -0.0870543 -0.0870543 -0.0870543 + 8800 0.88 0.68391103 0.68390923 -1.5210615e-07 -0.087091034 -0.087091034 -0.087091034 + 8810 0.881 0.68397797 0.6839762 -2.0967754e-07 -0.08712767 -0.08712767 -0.08712767 + 8820 0.882 0.68404473 0.684043 -2.6286386e-07 -0.08716421 -0.08716421 -0.08716421 + 8830 0.883 0.68411129 0.68410963 -3.1052897e-07 -0.087200653 -0.087200653 -0.087200653 + 8840 0.884 0.68417767 0.68417607 -3.5165794e-07 -0.087237 -0.087237 -0.087237 + 8850 0.885 0.68424386 0.68424234 -3.8537866e-07 -0.087273251 -0.087273251 -0.087273251 + 8860 0.886 0.68430987 0.68430842 -4.1098047e-07 -0.087309405 -0.087309405 -0.087309405 + 8870 0.887 0.68437569 0.68437433 -4.2792911e-07 -0.087345464 -0.087345464 -0.087345464 + 8880 0.888 0.68444133 0.68444006 -4.3587796e-07 -0.087381427 -0.087381427 -0.087381427 + 8890 0.889 0.68450679 0.68450561 -4.3467519e-07 -0.087417295 -0.087417295 -0.087417295 + 8900 0.89 0.68457207 0.68457098 -4.243667e-07 -0.087453068 -0.087453068 -0.087453068 + 8910 0.891 0.68463718 0.68463616 -4.0519472e-07 -0.087488746 -0.087488746 -0.087488746 + 8920 0.892 0.6847021 0.68470117 -3.7759228e-07 -0.087524329 -0.087524329 -0.087524329 + 8930 0.893 0.68476685 0.68476599 -3.4217351e-07 -0.087559817 -0.087559817 -0.087559817 + 8940 0.894 0.68483143 0.68483063 -2.9972001e-07 -0.087595211 -0.087595211 -0.087595211 + 8950 0.895 0.68489583 0.68489509 -2.5116375e-07 -0.087630512 -0.087630512 -0.087630512 + 8960 0.896 0.68496007 0.68495936 -1.975666e-07 -0.087665718 -0.087665718 -0.087665718 + 8970 0.897 0.68502413 0.68502346 -1.4009717e-07 -0.087700831 -0.087700831 -0.087700831 + 8980 0.898 0.68508802 0.68508737 -8.0005408e-08 -0.08773585 -0.08773585 -0.08773585 + 8990 0.899 0.68515174 0.68515109 -1.8595382e-08 -0.087770776 -0.087770776 -0.087770776 + 9000 0.9 0.68521529 0.68521464 4.2802966e-08 -0.087805609 -0.087805609 -0.087805609 + 9010 0.901 0.68527867 0.685278 1.0286263e-07 -0.087840349 -0.087840349 -0.087840349 + 9020 0.902 0.68534188 0.68534119 1.6028822e-07 -0.087874996 -0.087874996 -0.087874996 + 9030 0.903 0.68540493 0.68540419 2.1384393e-07 -0.087909551 -0.087909551 -0.087909551 + 9040 0.904 0.68546781 0.68546701 2.6238014e-07 -0.087944014 -0.087944014 -0.087944014 + 9050 0.905 0.68553051 0.68552966 3.0485816e-07 -0.087978385 -0.087978385 -0.087978385 + 9060 0.906 0.68559305 0.68559213 3.4037244e-07 -0.088012665 -0.088012665 -0.088012665 + 9070 0.907 0.68565542 0.68565442 3.6817e-07 -0.088046852 -0.088046852 -0.088046852 + 9080 0.908 0.68571762 0.68571654 3.8766636e-07 -0.088080949 -0.088080949 -0.088080949 + 9090 0.909 0.68577965 0.68577848 3.9845796e-07 -0.088114954 -0.088114954 -0.088114954 + 9100 0.91 0.68584151 0.68584025 4.0033051e-07 -0.088148868 -0.088148868 -0.088148868 + 9110 0.911 0.6859032 0.68590186 3.9326329e-07 -0.088182692 -0.088182692 -0.088182692 + 9120 0.912 0.68596471 0.68596329 3.7742924e-07 -0.088216425 -0.088216425 -0.088216425 + 9130 0.913 0.68602606 0.68602455 3.5319086e-07 -0.088250067 -0.088250067 -0.088250067 + 9140 0.914 0.68608723 0.68608565 3.2109199e-07 -0.08828362 -0.08828362 -0.08828362 + 9150 0.915 0.68614823 0.68614659 2.8184568e-07 -0.088317083 -0.088317083 -0.088317083 + 9160 0.916 0.68620905 0.68620735 2.3631841e-07 -0.088350456 -0.088350456 -0.088350456 + 9170 0.917 0.6862697 0.68626796 1.8551105e-07 -0.08838374 -0.08838374 -0.08838374 + 9180 0.918 0.68633018 0.6863284 1.3053687e-07 -0.088416934 -0.088416934 -0.088416934 + 9190 0.919 0.68639049 0.68638868 7.2597189e-08 -0.088450039 -0.088450039 -0.088450039 + 9200 0.92 0.68645062 0.6864488 1.2955167e-08 -0.088483056 -0.088483056 -0.088483056 + 9210 0.921 0.68651058 0.68650876 -4.7091734e-08 -0.088515984 -0.088515984 -0.088515984 + 9220 0.922 0.68657036 0.68656856 -1.0623996e-07 -0.088548823 -0.088548823 -0.088548823 + 9230 0.923 0.68662998 0.6866282 -1.6320817e-07 -0.088581574 -0.088581574 -0.088581574 + 9240 0.924 0.68668942 0.68668769 -2.1676499e-07 -0.088614237 -0.088614237 -0.088614237 + 9250 0.925 0.68674869 0.68674701 -2.6575568e-07 -0.088646812 -0.088646812 -0.088646812 + 9260 0.926 0.68680779 0.68680617 -3.0912704e-07 -0.0886793 -0.0886793 -0.0886793 + 9270 0.927 0.68686673 0.68686517 -3.4595009e-07 -0.0887117 -0.0887117 -0.0887117 + 9280 0.928 0.6869255 0.68692401 -3.7544002e-07 -0.088744013 -0.088744013 -0.088744013 + 9290 0.929 0.6869841 0.68698269 -3.9697293e-07 -0.088776239 -0.088776239 -0.088776239 + 9300 0.93 0.68704254 0.68704121 -4.1009912e-07 -0.088808378 -0.088808378 -0.088808378 + 9310 0.931 0.68710081 0.68709956 -4.1455252e-07 -0.088840431 -0.088840431 -0.088840431 + 9320 0.932 0.68715892 0.68715776 -4.1025607e-07 -0.088872397 -0.088872397 -0.088872397 + 9330 0.933 0.68721687 0.68721579 -3.9732309e-07 -0.088904277 -0.088904277 -0.088904277 + 9340 0.934 0.68727466 0.68727366 -3.7605442e-07 -0.088936071 -0.088936071 -0.088936071 + 9350 0.935 0.68733229 0.68733137 -3.4693151e-07 -0.088967779 -0.088967779 -0.088967779 + 9360 0.936 0.68738977 0.68738891 -3.1060559e-07 -0.088999401 -0.088999401 -0.088999401 + 9370 0.937 0.68744709 0.68744628 -2.678832e-07 -0.089030938 -0.089030938 -0.089030938 + 9380 0.938 0.68750426 0.6875035 -2.1970834e-07 -0.08906239 -0.08906239 -0.08906239 + 9390 0.939 0.68756127 0.68756055 -1.671416e-07 -0.089093757 -0.089093757 -0.089093757 + 9400 0.94 0.68761812 0.68761743 -1.1133694e-07 -0.089125039 -0.089125039 -0.089125039 + 9410 0.941 0.68767483 0.68767415 -5.3516312e-08 -0.089156237 -0.089156237 -0.089156237 + 9420 0.942 0.68773138 0.6877307 5.0570456e-09 -0.08918735 -0.08918735 -0.08918735 + 9430 0.943 0.68778778 0.68778709 6.3106191e-08 -0.089218379 -0.089218379 -0.089218379 + 9440 0.944 0.68784403 0.68784332 1.1936833e-07 -0.089249324 -0.089249324 -0.089249324 + 9450 0.945 0.68790013 0.68789939 1.7262227e-07 -0.089280185 -0.089280185 -0.089280185 + 9460 0.946 0.68795608 0.68795529 2.21715e-07 -0.089310962 -0.089310962 -0.089310962 + 9470 0.947 0.68801188 0.68801103 2.6558658e-07 -0.089341657 -0.089341657 -0.089341657 + 9480 0.948 0.68806752 0.68806662 3.0329316e-07 -0.089372267 -0.089372267 -0.089372267 + 9490 0.949 0.68812302 0.68812204 3.3402726e-07 -0.089402795 -0.089402795 -0.089402795 + 9500 0.95 0.68817836 0.6881773 3.5713511e-07 -0.08943324 -0.08943324 -0.08943324 + 9510 0.951 0.68823355 0.68823241 3.721306e-07 -0.089463603 -0.089463603 -0.089463603 + 9520 0.952 0.68828858 0.68828737 3.7870557e-07 -0.089493883 -0.089493883 -0.089493883 + 9530 0.953 0.68834347 0.68834217 3.7673613e-07 -0.08952408 -0.08952408 -0.08952408 + 9540 0.954 0.68839819 0.68839682 3.6628503e-07 -0.089554196 -0.089554196 -0.089554196 + 9550 0.955 0.68845277 0.68845131 3.4759992e-07 -0.08958423 -0.08958423 -0.08958423 + 9560 0.956 0.68850719 0.68850566 3.2110753e-07 -0.089614182 -0.089614182 -0.089614182 + 9570 0.957 0.68856145 0.68855986 2.8740406e-07 -0.089644053 -0.089644053 -0.089644053 + 9580 0.958 0.68861556 0.68861391 2.4724178e-07 -0.089673843 -0.089673843 -0.089673843 + 9590 0.959 0.68866951 0.68866781 2.0151231e-07 -0.089703551 -0.089703551 -0.089703551 + 9600 0.96 0.6887233 0.68872157 1.5122687e-07 -0.089733179 -0.089733179 -0.089733179 + 9610 0.961 0.68877694 0.68877518 9.749396e-08 -0.089762726 -0.089762726 -0.089762726 + 9620 0.962 0.68883043 0.68882864 4.1494944e-08 -0.089792192 -0.089792192 -0.089792192 + 9630 0.963 0.68888376 0.68888197 -1.5541893e-08 -0.089821578 -0.089821578 -0.089821578 + 9640 0.964 0.68893693 0.68893515 -7.2368278e-08 -0.089850884 -0.089850884 -0.089850884 + 9650 0.965 0.68898995 0.68898818 -1.2774327e-07 -0.089880111 -0.089880111 -0.089880111 + 9660 0.966 0.68904281 0.68904108 -1.8046035e-07 -0.089909257 -0.089909257 -0.089909257 + 9670 0.967 0.68909552 0.68909383 -2.2937375e-07 -0.089938324 -0.089938324 -0.089938324 + 9680 0.968 0.68914808 0.68914644 -2.7342333e-07 -0.089967312 -0.089967312 -0.089967312 + 9690 0.969 0.68920048 0.6891989 -3.1165765e-07 -0.08999622 -0.08999622 -0.08999622 + 9700 0.97 0.68925273 0.68925122 -3.4325447e-07 -0.09002505 -0.09002505 -0.09002505 + 9710 0.971 0.68930484 0.6893034 -3.6753853e-07 -0.090053801 -0.090053801 -0.090053801 + 9720 0.972 0.6893568 0.68935543 -3.8399599e-07 -0.090082473 -0.090082473 -0.090082473 + 9730 0.973 0.6894086 0.68940732 -3.9228536e-07 -0.090111067 -0.090111067 -0.090111067 + 9740 0.974 0.68946027 0.68945906 -3.9224459e-07 -0.090139582 -0.090139582 -0.090139582 + 9750 0.975 0.68951179 0.68951066 -3.8389426e-07 -0.09016802 -0.09016802 -0.09016802 + 9760 0.976 0.68956316 0.68956211 -3.6743677e-07 -0.09019638 -0.09019638 -0.09019638 + 9770 0.977 0.68961439 0.68961341 -3.432515e-07 -0.090224662 -0.090224662 -0.090224662 + 9780 0.978 0.68966548 0.68966457 -3.1188616e-07 -0.090252867 -0.090252867 -0.090252867 + 9790 0.979 0.68971643 0.68971558 -2.7404444e-07 -0.090280995 -0.090280995 -0.090280995 + 9800 0.98 0.68976724 0.68976644 -2.3057029e-07 -0.090309045 -0.090309045 -0.090309045 + 9810 0.981 0.68981792 0.68981715 -1.8242913e-07 -0.090337019 -0.090337019 -0.090337019 + 9820 0.982 0.68986845 0.68986772 -1.3068644e-07 -0.090364916 -0.090364916 -0.090364916 + 9830 0.983 0.68991885 0.68991813 -7.6484243e-08 -0.090392736 -0.090392736 -0.090392736 + 9840 0.984 0.68996912 0.6899684 -2.1015886e-08 -0.09042048 -0.09042048 -0.09042048 + 9850 0.985 0.69001924 0.69001853 3.4500202e-08 -0.090448148 -0.090448148 -0.090448148 + 9860 0.986 0.69006924 0.6900685 8.8847271e-08 -0.090475741 -0.090475741 -0.090475741 + 9870 0.987 0.69011909 0.69011833 1.4083692e-07 -0.090503257 -0.090503257 -0.090503257 + 9880 0.988 0.69016881 0.69016801 1.8933509e-07 -0.090530698 -0.090530698 -0.090530698 + 9890 0.989 0.6902184 0.69021755 2.3328683e-07 -0.090558063 -0.090558063 -0.090558063 + 9900 0.99 0.69026785 0.69026695 2.7173925e-07 -0.090585353 -0.090585353 -0.090585353 + 9910 0.991 0.69031717 0.6903162 3.038622e-07 -0.090612569 -0.090612569 -0.090612569 + 9920 0.992 0.69036635 0.69036531 3.2896626e-07 -0.090639709 -0.090639709 -0.090639709 + 9930 0.993 0.69041539 0.69041428 3.4651751e-07 -0.090666775 -0.090666775 -0.090666775 + 9940 0.994 0.69046429 0.69046311 3.56149e-07 -0.090693766 -0.090693766 -0.090693766 + 9950 0.995 0.69051306 0.6905118 3.5766835e-07 -0.090720683 -0.090720683 -0.090720683 + 9960 0.996 0.69056169 0.69056035 3.5106169e-07 -0.090747526 -0.090747526 -0.090747526 + 9970 0.997 0.69061018 0.69060877 3.3649353e-07 -0.090774295 -0.090774295 -0.090774295 + 9980 0.998 0.69065854 0.69065705 3.143028e-07 -0.09080099 -0.09080099 -0.09080099 + 9990 0.999 0.69070675 0.6907052 2.8499502e-07 -0.090827612 -0.090827612 -0.090827612 + 10000 1 0.69075483 0.69075321 2.4923086e-07 -0.09085416 -0.09085416 -0.09085416 + 10010 1.001 0.69080276 0.6908011 2.0781127e-07 -0.090880635 -0.090880635 -0.090880635 + 10020 1.002 0.69085056 0.69084885 1.6165961e-07 -0.090907037 -0.090907037 -0.090907037 + 10030 1.003 0.69089821 0.69089648 1.118011e-07 -0.090933367 -0.090933367 -0.090933367 + 10040 1.004 0.69094572 0.69094397 5.9340085e-08 -0.090959623 -0.090959623 -0.090959623 + 10050 1.005 0.6909931 0.69099134 5.4355473e-09 -0.090985807 -0.090985807 -0.090985807 + 10060 1.006 0.69104033 0.69103857 -4.8724427e-08 -0.091011919 -0.091011919 -0.091011919 + 10070 1.007 0.69108743 0.69108568 -1.0194886e-07 -0.091037959 -0.091037959 -0.091037959 + 10080 1.008 0.69113438 0.69113266 -1.5307005e-07 -0.091063927 -0.091063927 -0.091063927 + 10090 1.009 0.6911812 0.69117952 -2.0096923e-07 -0.091089823 -0.091089823 -0.091089823 + 10100 1.01 0.69122788 0.69122624 -2.4460104e-07 -0.091115648 -0.091115648 -0.091115648 + 10110 1.011 0.69127443 0.69127284 -2.8301635e-07 -0.091141401 -0.091141401 -0.091141401 + 10120 1.012 0.69132084 0.69131931 -3.1538295e-07 -0.091167083 -0.091167083 -0.091167083 + 10130 1.013 0.69136711 0.69136565 -3.4100363e-07 -0.091192693 -0.091192693 -0.091192693 + 10140 1.014 0.69141325 0.69141186 -3.5933117e-07 -0.091218233 -0.091218233 -0.091218233 + 10150 1.015 0.69145926 0.69145794 -3.699801e-07 -0.091243703 -0.091243703 -0.091243703 + 10160 1.016 0.69150514 0.6915039 -3.7273481e-07 -0.091269102 -0.091269102 -0.091269102 + 10170 1.017 0.69155088 0.69154972 -3.6755394e-07 -0.09129443 -0.09129443 -0.09129443 + 10180 1.018 0.6915965 0.69159541 -3.5457093e-07 -0.091319688 -0.091319688 -0.091319688 + 10190 1.019 0.69164199 0.69164097 -3.3409064e-07 -0.091344877 -0.091344877 -0.091344877 + 10200 1.02 0.69168736 0.6916864 -3.0658233e-07 -0.091369995 -0.091369995 -0.091369995 + 10210 1.021 0.69173259 0.69173169 -2.7266894e-07 -0.091395044 -0.091395044 -0.091395044 + 10220 1.022 0.69177771 0.69177686 -2.3311303e-07 -0.091420023 -0.091420023 -0.091420023 + 10230 1.023 0.6918227 0.69182189 -1.8879967e-07 -0.091444933 -0.091444933 -0.091444933 + 10240 1.024 0.69186757 0.69186679 -1.407167e-07 -0.091469774 -0.091469774 -0.091469774 + 10250 1.025 0.69191231 0.69191155 -8.993269e-08 -0.091494546 -0.091494546 -0.091494546 + 10260 1.026 0.69195693 0.69195619 -3.7573278e-08 -0.091519249 -0.091519249 -0.091519249 + 10270 1.027 0.69200144 0.69200069 1.5203814e-08 -0.091543884 -0.091543884 -0.091543884 + 10280 1.028 0.69204582 0.69204506 6.7234351e-08 -0.09156845 -0.09156845 -0.09156845 + 10290 1.029 0.69209008 0.69208929 1.1737327e-07 -0.091592948 -0.091592948 -0.091592948 + 10300 1.03 0.69213422 0.6921334 1.6451988e-07 -0.091617378 -0.091617378 -0.091617378 + 10310 1.031 0.69217824 0.69217738 2.0764205e-07 -0.09164174 -0.09164174 -0.09164174 + 10320 1.032 0.69222213 0.69222122 2.4579878e-07 -0.091666034 -0.091666034 -0.091666034 + 10330 1.033 0.69226591 0.69226494 2.7816081e-07 -0.091690261 -0.091690261 -0.091690261 + 10340 1.034 0.69230957 0.69230853 3.0402864e-07 -0.09171442 -0.09171442 -0.09171442 + 10350 1.035 0.6923531 0.692352 3.2284766e-07 -0.091738512 -0.091738512 -0.091738512 + 10360 1.036 0.69239651 0.69239534 3.3422007e-07 -0.091762537 -0.091762537 -0.091762537 + 10370 1.037 0.6924398 0.69243855 3.3791336e-07 -0.091786495 -0.091786495 -0.091786495 + 10380 1.038 0.69248296 0.69248164 3.33865e-07 -0.091810386 -0.091810386 -0.091810386 + 10390 1.039 0.69252601 0.69252461 3.2218348e-07 -0.091834211 -0.091834211 -0.091834211 + 10400 1.04 0.69256892 0.69256746 3.0314554e-07 -0.091857969 -0.091857969 -0.091857969 + 10410 1.041 0.69261172 0.69261019 2.7718967e-07 -0.091881662 -0.091881662 -0.091881662 + 10420 1.042 0.69265438 0.6926528 2.4490607e-07 -0.091905288 -0.091905288 -0.091905288 + 10430 1.043 0.69269693 0.6926953 2.0702329e-07 -0.091928848 -0.091928848 -0.091928848 + 10440 1.044 0.69273934 0.69273767 1.643918e-07 -0.091952342 -0.091952342 -0.091952342 + 10450 1.045 0.69278164 0.69277993 1.1796495e-07 -0.091975771 -0.091975771 -0.091975771 + 10460 1.046 0.6928238 0.69282208 6.8777704e-08 -0.091999135 -0.091999135 -0.091999135 + 10470 1.047 0.69286584 0.69286411 1.7923524e-08 -0.092022433 -0.092022433 -0.092022433 + 10480 1.048 0.69290776 0.69290602 -3.3469864e-08 -0.092045666 -0.092045666 -0.092045666 + 10490 1.049 0.69294955 0.69294782 -8.4265498e-08 -0.092068835 -0.092068835 -0.092068835 + 10500 1.05 0.69299121 0.69298951 -1.3334232e-07 -0.092091938 -0.092091938 -0.092091938 + 10510 1.051 0.69303276 0.69303108 -1.7961993e-07 -0.092114977 -0.092114977 -0.092114977 + 10520 1.052 0.69307417 0.69307254 -2.2208238e-07 -0.092137952 -0.092137952 -0.092137952 + 10530 1.053 0.69311547 0.69311388 -2.5980046e-07 -0.092160863 -0.092160863 -0.092160863 + 10540 1.054 0.69315664 0.69315511 -2.9195212e-07 -0.092183709 -0.092183709 -0.092183709 + 10550 1.055 0.6931977 0.69319623 -3.1784032e-07 -0.092206492 -0.092206492 -0.092206492 + 10560 1.056 0.69323863 0.69323723 -3.3690823e-07 -0.09222921 -0.09222921 -0.09222921 + 10570 1.057 0.69327945 0.69327812 -3.4875121e-07 -0.092251865 -0.092251865 -0.092251865 + 10580 1.058 0.69332014 0.69331888 -3.5312541e-07 -0.092274457 -0.092274457 -0.092274457 + 10590 1.059 0.69336073 0.69335954 -3.4995279e-07 -0.092296986 -0.092296986 -0.092296986 + 10600 1.06 0.69340119 0.69340007 -3.393225e-07 -0.092319451 -0.092319451 -0.092319451 + 10610 1.061 0.69344154 0.69344049 -3.2148851e-07 -0.092341854 -0.092341854 -0.092341854 + 10620 1.062 0.69348178 0.69348079 -2.9686361e-07 -0.092364193 -0.092364193 -0.092364193 + 10630 1.063 0.69352191 0.69352097 -2.6600991e-07 -0.09238647 -0.09238647 -0.09238647 + 10640 1.064 0.69356192 0.69356104 -2.2962607e-07 -0.092408685 -0.092408685 -0.092408685 + 10650 1.065 0.69360183 0.69360098 -1.8853149e-07 -0.092430837 -0.092430837 -0.092430837 + 10660 1.066 0.69364162 0.69364081 -1.4364793e-07 -0.092452928 -0.092452928 -0.092452928 + 10670 1.067 0.69368131 0.69368052 -9.5978821e-08 -0.092474956 -0.092474956 -0.092474956 + 10680 1.068 0.69372088 0.69372011 -4.6586875e-08 -0.092496922 -0.092496922 -0.092496922 + 10690 1.069 0.69376035 0.69375958 3.4295913e-09 -0.092518827 -0.092518827 -0.092518827 + 10700 1.07 0.69379971 0.69379893 5.2961074e-08 -0.09254067 -0.09254067 -0.09254067 + 10710 1.071 0.69383897 0.69383816 1.0091149e-07 -0.092562452 -0.092562452 -0.092562452 + 10720 1.072 0.69387811 0.69387728 1.4622244e-07 -0.092584173 -0.092584173 -0.092584173 + 10730 1.073 0.69391715 0.69391628 1.8789655e-07 -0.092605833 -0.092605833 -0.092605833 + 10740 1.074 0.69395608 0.69395516 2.2501949e-07 -0.092627432 -0.092627432 -0.092627432 + 10750 1.075 0.69399491 0.69399393 2.5677998e-07 -0.09264897 -0.09264897 -0.09264897 + 10760 1.076 0.69403362 0.69403259 2.824876e-07 -0.092670448 -0.092670448 -0.092670448 + 10770 1.077 0.69407223 0.69407113 3.0158779e-07 -0.092691865 -0.092691865 -0.092691865 + 10780 1.078 0.69411073 0.69410956 3.1367381e-07 -0.092713222 -0.092713222 -0.092713222 + 10790 1.079 0.69414911 0.69414788 3.1849546e-07 -0.092734519 -0.092734519 -0.092734519 + 10800 1.08 0.69418739 0.69418608 3.1596425e-07 -0.092755756 -0.092755756 -0.092755756 + 10810 1.081 0.69422556 0.69422418 3.0615497e-07 -0.092776933 -0.092776933 -0.092776933 + 10820 1.082 0.69426361 0.69426217 2.8930369e-07 -0.092798051 -0.092798051 -0.092798051 + 10830 1.083 0.69430156 0.69430006 2.6580209e-07 -0.092819109 -0.092819109 -0.092819109 + 10840 1.084 0.69433939 0.69433784 2.3618848e-07 -0.092840108 -0.092840108 -0.092840108 + 10850 1.085 0.69437711 0.69437551 2.0113546e-07 -0.092861048 -0.092861048 -0.092861048 + 10860 1.086 0.69441472 0.69441308 1.6143468e-07 -0.092881928 -0.092881928 -0.092881928 + 10870 1.087 0.69445222 0.69445054 1.1797904e-07 -0.09290275 -0.09290275 -0.09290275 + 10880 1.088 0.6944896 0.6944879 7.1742582e-08 -0.092923513 -0.092923513 -0.092923513 + 10890 1.089 0.69452688 0.69452516 2.3758699e-08 -0.092944218 -0.092944218 -0.092944218 + 10900 1.09 0.69456404 0.69456232 -2.4902945e-08 -0.092964864 -0.092964864 -0.092964864 + 10910 1.091 0.69460108 0.69459938 -7.3160257e-08 -0.092985452 -0.092985452 -0.092985452 + 10920 1.092 0.69463802 0.69463633 -1.1994277e-07 -0.093005982 -0.093005982 -0.093005982 + 10930 1.093 0.69467485 0.69467319 -1.642154e-07 -0.093026454 -0.093026454 -0.093026454 + 10940 1.094 0.69471156 0.69470994 -2.0500133e-07 -0.093046868 -0.093046868 -0.093046868 + 10950 1.095 0.69474817 0.69474659 -2.4140361e-07 -0.093067225 -0.093067225 -0.093067225 + 10960 1.096 0.69478466 0.69478314 -2.7262485e-07 -0.093087524 -0.093087524 -0.093087524 + 10970 1.097 0.69482105 0.69481958 -2.9798474e-07 -0.093107766 -0.093107766 -0.093107766 + 10980 1.098 0.69485733 0.69485593 -3.1693487e-07 -0.09312795 -0.09312795 -0.09312795 + 10990 1.099 0.69489351 0.69489217 -3.2907063e-07 -0.093148078 -0.093148078 -0.093148078 + 11000 1.1 0.69492958 0.69492831 -3.3413983e-07 -0.093168148 -0.093168148 -0.093168148 + 11010 1.101 0.69496554 0.69496434 -3.3204797e-07 -0.093188162 -0.093188162 -0.093188162 + 11020 1.102 0.69500141 0.69500027 -3.2285996e-07 -0.09320812 -0.09320812 -0.09320812 + 11030 1.103 0.69503717 0.69503609 -3.0679831e-07 -0.09322802 -0.09322802 -0.09322802 + 11040 1.104 0.69507283 0.69507181 -2.8423779e-07 -0.093247865 -0.093247865 -0.093247865 + 11050 1.105 0.69510839 0.69510743 -2.5569675e-07 -0.093267653 -0.093267653 -0.093267653 + 11060 1.106 0.69514385 0.69514293 -2.2182526e-07 -0.093287386 -0.093287386 -0.093287386 + 11070 1.107 0.69517921 0.69517834 -1.8339032e-07 -0.093307062 -0.093307062 -0.093307062 + 11080 1.108 0.69521447 0.69521363 -1.4125853e-07 -0.093326683 -0.093326683 -0.093326683 + 11090 1.109 0.69524964 0.69524882 -9.6376583e-08 -0.093346248 -0.093346248 -0.093346248 + 11100 1.11 0.69528471 0.69528391 -4.9750004e-08 -0.093365758 -0.093365758 -0.093365758 + 11110 1.111 0.69531969 0.69531888 -2.4206371e-09 -0.093385213 -0.093385213 -0.093385213 + 11120 1.112 0.69535457 0.69535375 4.4556621e-08 -0.093404612 -0.093404612 -0.093404612 + 11130 1.113 0.69538935 0.69538852 9.0137329e-08 -0.093423957 -0.093423957 -0.093423957 + 11140 1.114 0.69542404 0.69542318 1.3331072e-07 -0.093443247 -0.093443247 -0.093443247 + 11150 1.115 0.69545863 0.69545774 1.7312213e-07 -0.093462482 -0.093462482 -0.093462482 + 11160 1.116 0.69549313 0.69549219 2.0869409e-07 -0.093481662 -0.093481662 -0.093481662 + 11170 1.117 0.69552753 0.69552654 2.3924572e-07 -0.093500788 -0.093500788 -0.093500788 + 11180 1.118 0.69556183 0.69556079 2.6410983e-07 -0.09351986 -0.09351986 -0.09351986 + 11190 1.119 0.69559604 0.69559493 2.8274756e-07 -0.093538877 -0.093538877 -0.093538877 + 11200 1.12 0.69563015 0.69562898 2.9476002e-07 -0.093557841 -0.093557841 -0.093557841 + 11210 1.121 0.69566416 0.69566293 2.9989688e-07 -0.093576751 -0.093576751 -0.093576751 + 11220 1.122 0.69569807 0.69569677 2.9806158e-07 -0.093595607 -0.093595607 -0.093595607 + 11230 1.123 0.69573189 0.69573053 2.8931308e-07 -0.09361441 -0.09361441 -0.09361441 + 11240 1.124 0.69576561 0.69576418 2.7386421e-07 -0.093633159 -0.093633159 -0.093633159 + 11250 1.125 0.69579923 0.69579774 2.5207657e-07 -0.093651855 -0.093651855 -0.093651855 + 11260 1.126 0.69583274 0.69583121 2.2445205e-07 -0.093670497 -0.093670497 -0.093670497 + 11270 1.127 0.69586616 0.69586458 1.9162136e-07 -0.093689087 -0.093689087 -0.093689087 + 11280 1.128 0.69589948 0.69589786 1.5432967e-07 -0.093707624 -0.093707624 -0.093707624 + 11290 1.129 0.6959327 0.69593104 1.1341969e-07 -0.093726108 -0.093726108 -0.093726108 + 11300 1.13 0.69596581 0.69596414 6.9812661e-08 -0.09374454 -0.09374454 -0.09374454 + 11310 1.131 0.69599883 0.69599714 2.4487635e-08 -0.093762919 -0.093762919 -0.093762919 + 11320 1.132 0.69603175 0.69603006 -2.1540494e-08 -0.093781246 -0.093781246 -0.093781246 + 11330 1.133 0.69606456 0.69606288 -6.7243707e-08 -0.093799521 -0.093799521 -0.093799521 + 11340 1.134 0.69609728 0.69609561 -1.1160382e-07 -0.093817744 -0.093817744 -0.093817744 + 11350 1.135 0.6961299 0.69612826 -1.5363517e-07 -0.093835915 -0.093835915 -0.093835915 + 11360 1.136 0.69616241 0.69616081 -1.9240649e-07 -0.093854034 -0.093854034 -0.093854034 + 11370 1.137 0.69619484 0.69619327 -2.2706161e-07 -0.093872101 -0.093872101 -0.093872101 + 11380 1.138 0.69622716 0.69622564 -2.5683832e-07 -0.093890118 -0.093890118 -0.093890118 + 11390 1.139 0.69625939 0.69625792 -2.8108514e-07 -0.093908082 -0.093908082 -0.093908082 + 11400 1.14 0.69629152 0.69629011 -2.9927565e-07 -0.093925996 -0.093925996 -0.093925996 + 11410 1.141 0.69632355 0.69632221 -3.1101987e-07 -0.093943859 -0.093943859 -0.093943859 + 11420 1.142 0.6963555 0.69635422 -3.1607265e-07 -0.09396167 -0.09396167 -0.09396167 + 11430 1.143 0.69638734 0.69638613 -3.143388e-07 -0.093979431 -0.093979431 -0.093979431 + 11440 1.144 0.6964191 0.69641795 -3.0587483e-07 -0.093997141 -0.093997141 -0.093997141 + 11450 1.145 0.69645077 0.69644968 -2.9088733e-07 -0.094014801 -0.094014801 -0.094014801 + 11460 1.146 0.69648235 0.69648132 -2.6972799e-07 -0.09403241 -0.09403241 -0.09403241 + 11470 1.147 0.69651384 0.69651286 -2.4288538e-07 -0.094049969 -0.094049969 -0.094049969 + 11480 1.148 0.69654524 0.6965443 -2.1097374e-07 -0.094067478 -0.094067478 -0.094067478 + 11490 1.149 0.69657655 0.69657565 -1.7471892e-07 -0.094084937 -0.094084937 -0.094084937 + 11500 1.15 0.69660777 0.69660691 -1.3494192e-07 -0.094102347 -0.094102347 -0.094102347 + 11510 1.151 0.69663891 0.69663807 -9.2540291e-08 -0.094119706 -0.094119706 -0.094119706 + 11520 1.152 0.69666997 0.69666913 -4.8467946e-08 -0.094137016 -0.094137016 -0.094137016 + 11530 1.153 0.69670094 0.6967001 -3.7136761e-09 -0.094154276 -0.094154276 -0.094154276 + 11540 1.154 0.69673182 0.69673098 4.0721009e-08 -0.094171487 -0.094171487 -0.094171487 + 11550 1.155 0.69676262 0.69676176 8.3844293e-08 -0.094188649 -0.094188649 -0.094188649 + 11560 1.156 0.69679333 0.69679245 1.2469619e-07 -0.094205762 -0.094205762 -0.094205762 + 11570 1.157 0.69682396 0.69682304 1.623699e-07 -0.094222826 -0.094222826 -0.094222826 + 11580 1.158 0.6968545 0.69685355 1.9603199e-07 -0.094239841 -0.094239841 -0.094239841 + 11590 1.159 0.69688496 0.69688396 2.2494077e-07 -0.094256808 -0.094256808 -0.094256808 + 11600 1.16 0.69691533 0.69691428 2.484627e-07 -0.094273726 -0.094273726 -0.094273726 + 11610 1.161 0.69694562 0.69694451 2.6608628e-07 -0.094290596 -0.094290596 -0.094290596 + 11620 1.162 0.69697582 0.69697465 2.7743315e-07 -0.094307417 -0.094307417 -0.094307417 + 11630 1.163 0.69700594 0.6970047 2.8226625e-07 -0.09432419 -0.09432419 -0.09432419 + 11640 1.164 0.69703596 0.69703466 2.8049475e-07 -0.094340915 -0.094340915 -0.094340915 + 11650 1.165 0.6970659 0.69706454 2.7217574e-07 -0.094357593 -0.094357593 -0.094357593 + 11660 1.166 0.69709575 0.69709433 2.5751257e-07 -0.094374222 -0.094374222 -0.094374222 + 11670 1.167 0.69712551 0.69712404 2.3684995e-07 -0.094390804 -0.094390804 -0.094390804 + 11680 1.168 0.69715518 0.69715366 2.106659e-07 -0.094407339 -0.094407339 -0.094407339 + 11690 1.169 0.69718477 0.6971832 1.7956068e-07 -0.094423826 -0.094423826 -0.094423826 + 11700 1.17 0.69721426 0.69721266 1.4424311e-07 -0.094440266 -0.094440266 -0.094440266 + 11710 1.171 0.69724367 0.69724203 1.0551442e-07 -0.094456659 -0.094456659 -0.094456659 + 11720 1.172 0.69727298 0.69727133 6.4250108e-08 -0.094473004 -0.094473004 -0.094473004 + 11730 1.173 0.69730221 0.69730054 2.1380133e-08 -0.094489303 -0.094489303 -0.094489303 + 11740 1.174 0.69733134 0.69732967 -2.2132e-08 -0.094505556 -0.094505556 -0.094505556 + 11750 1.175 0.69736039 0.69735873 -6.5310898e-08 -0.094521761 -0.094521761 -0.094521761 + 11760 1.176 0.69738934 0.6973877 -1.0719114e-07 -0.09453792 -0.09453792 -0.09453792 + 11770 1.177 0.69741821 0.69741659 -1.4683886e-07 -0.094554033 -0.094554033 -0.094554033 + 11780 1.178 0.69744699 0.6974454 -1.8337258e-07 -0.0945701 -0.0945701 -0.0945701 + 11790 1.179 0.69747568 0.69747414 -2.1598279e-07 -0.09458612 -0.09458612 -0.09458612 + 11800 1.18 0.69750429 0.69750279 -2.4394994e-07 -0.094602095 -0.094602095 -0.094602095 + 11810 1.181 0.69753281 0.69753136 -2.6666025e-07 -0.094618023 -0.094618023 -0.094618023 + 11820 1.182 0.69756125 0.69755985 -2.8361928e-07 -0.094633906 -0.094633906 -0.094633906 + 11830 1.183 0.6975896 0.69758826 -2.9446262e-07 -0.094649743 -0.094649743 -0.094649743 + 11840 1.184 0.69761786 0.69761659 -2.9896379e-07 -0.094665535 -0.094665535 -0.094665535 + 11850 1.185 0.69764605 0.69764483 -2.9703893e-07 -0.094681282 -0.094681282 -0.094681282 + 11860 1.186 0.69767415 0.697673 -2.8874832e-07 -0.094696983 -0.094696983 -0.094696983 + 11870 1.187 0.69770217 0.69770108 -2.742947e-07 -0.094712639 -0.094712639 -0.094712639 + 11880 1.188 0.69773012 0.69772907 -2.5401833e-07 -0.09472825 -0.09472825 -0.09472825 + 11890 1.189 0.69775798 0.69775698 -2.2838906e-07 -0.094743816 -0.094743816 -0.094743816 + 11900 1.19 0.69778576 0.69778481 -1.9799542e-07 -0.094759338 -0.094759338 -0.094759338 + 11910 1.191 0.69781347 0.69781255 -1.635312e-07 -0.094774815 -0.094774815 -0.094774815 + 11920 1.192 0.6978411 0.69784021 -1.257796e-07 -0.094790247 -0.094790247 -0.094790247 + 11930 1.193 0.69786866 0.69786778 -8.5595447e-08 -0.094805635 -0.094805635 -0.094805635 + 11940 1.194 0.69789613 0.69789527 -4.3885875e-08 -0.094820979 -0.094820979 -0.094820979 + 11950 1.195 0.69792354 0.69792268 -1.5898447e-09 -0.094836278 -0.094836278 -0.094836278 + 11960 1.196 0.69795086 0.69795 4.0342983e-08 -0.094851534 -0.094851534 -0.094851534 + 11970 1.197 0.69797812 0.69797723 8.097356e-08 -0.094866746 -0.094866746 -0.094866746 + 11980 1.198 0.69800529 0.69800438 1.1939448e-07 -0.094881913 -0.094881913 -0.094881913 + 11990 1.199 0.69803239 0.69803145 1.5475026e-07 -0.094897038 -0.094897038 -0.094897038 + 12000 1.2 0.69805942 0.69805844 1.8625635e-07 -0.094912118 -0.094912118 -0.094912118 + 12010 1.201 0.69808637 0.69808534 2.132166e-07 -0.094927155 -0.094927155 -0.094927155 + 12020 1.202 0.69811324 0.69811217 2.3503862e-07 -0.094942149 -0.094942149 -0.094942149 + 12030 1.203 0.69814004 0.69813891 2.512468e-07 -0.0949571 -0.0949571 -0.0949571 + 12040 1.204 0.69816676 0.69816557 2.614927e-07 -0.094972008 -0.094972008 -0.094972008 + 12050 1.205 0.6981934 0.69819216 2.6556253e-07 -0.094986872 -0.094986872 -0.094986872 + 12060 1.206 0.69821997 0.69821866 2.6338162e-07 -0.095001694 -0.095001694 -0.095001694 + 12070 1.207 0.69824646 0.69824509 2.550157e-07 -0.095016473 -0.095016473 -0.095016473 + 12080 1.208 0.69827286 0.69827145 2.4066914e-07 -0.09503121 -0.09503121 -0.09503121 + 12090 1.209 0.69829919 0.69829773 2.2067994e-07 -0.095045904 -0.095045904 -0.095045904 + 12100 1.21 0.69832545 0.69832393 1.9551185e-07 -0.095060555 -0.095060555 -0.095060555 + 12110 1.211 0.69835162 0.69835006 1.6574363e-07 -0.095075165 -0.095075165 -0.095075165 + 12120 1.212 0.69837771 0.69837612 1.3205574e-07 -0.095089732 -0.095089732 -0.095089732 + 12130 1.213 0.69840372 0.6984021 9.5214852e-08 -0.095104257 -0.095104257 -0.095104257 + 12140 1.214 0.69842965 0.69842802 5.6056405e-08 -0.09511874 -0.09511874 -0.09511874 + 12150 1.215 0.6984555 0.69845386 1.5465654e-08 -0.095133182 -0.095133182 -0.095133182 + 12160 1.216 0.69848127 0.69847963 -2.5642312e-08 -0.095147582 -0.095147582 -0.095147582 + 12170 1.217 0.69850697 0.69850533 -6.6343197e-08 -0.09516194 -0.09516194 -0.09516194 + 12180 1.218 0.69853258 0.69853096 -1.0572428e-07 -0.095176257 -0.095176257 -0.095176257 + 12190 1.219 0.69855811 0.69855651 -1.4290487e-07 -0.095190532 -0.095190532 -0.095190532 + 12200 1.22 0.69858357 0.698582 -1.7705601e-07 -0.095204766 -0.095204766 -0.095204766 + 12210 1.221 0.69860894 0.69860742 -2.0741899e-07 -0.095218959 -0.095218959 -0.095218959 + 12220 1.222 0.69863424 0.69863276 -2.3332213e-07 -0.095233111 -0.095233111 -0.095233111 + 12230 1.223 0.69865947 0.69865803 -2.5419574e-07 -0.095247223 -0.095247223 -0.095247223 + 12240 1.224 0.69868461 0.69868323 -2.6958459e-07 -0.095261293 -0.095261293 -0.095261293 + 12250 1.225 0.69870969 0.69870836 -2.7915786e-07 -0.095275323 -0.095275323 -0.095275323 + 12260 1.226 0.69873469 0.69873342 -2.8271628e-07 -0.095289312 -0.095289312 -0.095289312 + 12270 1.227 0.69875961 0.6987584 -2.8019621e-07 -0.095303261 -0.095303261 -0.095303261 + 12280 1.228 0.69878446 0.69878331 -2.716708e-07 -0.095317169 -0.095317169 -0.095317169 + 12290 1.229 0.69880924 0.69880814 -2.5734791e-07 -0.095331037 -0.095331037 -0.095331037 + 12300 1.23 0.69883396 0.6988329 -2.3756517e-07 -0.095344865 -0.095344865 -0.095344865 + 12310 1.231 0.6988586 0.69885759 -2.12782e-07 -0.095358653 -0.095358653 -0.095358653 + 12320 1.232 0.69888317 0.6988822 -1.8356899e-07 -0.095372401 -0.095372401 -0.095372401 + 12330 1.233 0.69890767 0.69890673 -1.5059482e-07 -0.09538611 -0.09538611 -0.09538611 + 12340 1.234 0.6989321 0.69893119 -1.1461091e-07 -0.095399778 -0.095399778 -0.095399778 + 12350 1.235 0.69895647 0.69895558 -7.6434352e-08 -0.095413407 -0.095413407 -0.095413407 + 12360 1.236 0.69898077 0.69897988 -3.6929391e-08 -0.095426997 -0.095426997 -0.095426997 + 12370 1.237 0.699005 0.69900412 3.0121756e-09 -0.095440547 -0.095440547 -0.095440547 + 12380 1.238 0.69902917 0.69902827 4.2491092e-08 -0.095454059 -0.095454059 -0.095454059 + 12390 1.239 0.69905327 0.69905236 8.0620895e-08 -0.095467531 -0.095467531 -0.095467531 + 12400 1.24 0.6990773 0.69907636 1.1654781e-07 -0.095480963 -0.095480963 -0.095480963 + 12410 1.241 0.69910126 0.6991003 1.4946989e-07 -0.095494357 -0.095494357 -0.095494357 + 12420 1.242 0.69912516 0.69912416 1.7865487e-07 -0.095507713 -0.095507713 -0.095507713 + 12430 1.243 0.69914899 0.69914795 2.0345652e-07 -0.095521029 -0.095521029 -0.095521029 + 12440 1.244 0.69917276 0.69917166 2.2332892e-07 -0.095534307 -0.095534307 -0.095534307 + 12450 1.245 0.69919645 0.69919531 2.3783848e-07 -0.095547546 -0.095547546 -0.095547546 + 12460 1.246 0.69922008 0.69921888 2.4667342e-07 -0.095560748 -0.095560748 -0.095560748 + 12470 1.247 0.69924364 0.69924238 2.4965047e-07 -0.09557391 -0.09557391 -0.09557391 + 12480 1.248 0.69926713 0.69926582 2.4671863e-07 -0.095587035 -0.095587035 -0.095587035 + 12490 1.249 0.69929055 0.69928918 2.3796002e-07 -0.095600121 -0.095600121 -0.095600121 + 12500 1.25 0.6993139 0.69931248 2.2358765e-07 -0.09561317 -0.09561317 -0.09561317 + 12510 1.251 0.69933718 0.69933572 2.0394029e-07 -0.095626181 -0.095626181 -0.095626181 + 12520 1.252 0.69936039 0.69935888 1.7947455e-07 -0.095639154 -0.095639154 -0.095639154 + 12530 1.253 0.69938353 0.69938198 1.5075424e-07 -0.095652089 -0.095652089 -0.095652089 + 12540 1.254 0.6994066 0.69940502 1.1843746e-07 -0.095664987 -0.095664987 -0.095664987 + 12550 1.255 0.69942959 0.69942799 8.3261482e-08 -0.095677847 -0.095677847 -0.095677847 + 12560 1.256 0.69945252 0.6994509 4.6025993e-08 -0.09569067 -0.09569067 -0.09569067 + 12570 1.257 0.69947537 0.69947375 7.5748999e-09 -0.095703456 -0.095703456 -0.095703456 + 12580 1.258 0.69949816 0.69949653 -3.1222777e-08 -0.095716205 -0.095716205 -0.095716205 + 12590 1.259 0.69952087 0.69951925 -6.9492541e-08 -0.095728916 -0.095728916 -0.095728916 + 12600 1.26 0.69954351 0.69954191 -1.0637412e-07 -0.095741591 -0.095741591 -0.095741591 + 12610 1.261 0.69956608 0.6995645 -1.4104082e-07 -0.095754229 -0.095754229 -0.095754229 + 12620 1.262 0.69958858 0.69958703 -1.7271803e-07 -0.09576683 -0.09576683 -0.09576683 + 12630 1.263 0.69961101 0.6996095 -2.0070054e-07 -0.095779394 -0.095779394 -0.095779394 + 12640 1.264 0.69963337 0.69963191 -2.2436827e-07 -0.095791923 -0.095791923 -0.095791923 + 12650 1.265 0.69965567 0.69965425 -2.4319998e-07 -0.095804414 -0.095804414 -0.095804414 + 12660 1.266 0.6996779 0.69967653 -2.5678477e-07 -0.095816869 -0.095816869 -0.095816869 + 12670 1.267 0.69970006 0.69969874 -2.6483105e-07 -0.095829289 -0.095829289 -0.095829289 + 12680 1.268 0.69972215 0.69972089 -2.6717277e-07 -0.095841672 -0.095841672 -0.095841672 + 12690 1.269 0.69974418 0.69974298 -2.6377289e-07 -0.095854019 -0.095854019 -0.095854019 + 12700 1.27 0.69976615 0.699765 -2.5472381e-07 -0.09586633 -0.09586633 -0.09586633 + 12710 1.271 0.69978805 0.69978695 -2.40245e-07 -0.095878605 -0.095878605 -0.095878605 + 12720 1.272 0.69980989 0.69980883 -2.2067767e-07 -0.095890844 -0.095890844 -0.095890844 + 12730 1.273 0.69983167 0.69983065 -1.964768e-07 -0.095903048 -0.095903048 -0.095903048 + 12740 1.274 0.69985339 0.69985241 -1.682006e-07 -0.095915217 -0.095915217 -0.095915217 + 12750 1.275 0.69987504 0.69987409 -1.3649759e-07 -0.09592735 -0.09592735 -0.09592735 + 12760 1.276 0.69989664 0.69989571 -1.0209182e-07 -0.095939448 -0.095939448 -0.095939448 + 12770 1.277 0.69991818 0.69991726 -6.5766278e-08 -0.09595151 -0.09595151 -0.09595151 + 12780 1.278 0.69993965 0.69993874 -2.8345147e-08 -0.095963537 -0.095963537 -0.095963537 + 12790 1.279 0.69996107 0.69996016 9.3249255e-09 -0.09597553 -0.09597553 -0.09597553 + 12800 1.28 0.69998243 0.69998151 4.6393961e-08 -0.095987487 -0.095987487 -0.095987487 + 12810 1.281 0.70000373 0.70000279 8.2027829e-08 -0.09599941 -0.09599941 -0.09599941 + 12820 1.282 0.70002497 0.70002401 1.1542701e-07 -0.096011298 -0.096011298 -0.096011298 + 12830 1.283 0.70004615 0.70004516 1.4584454e-07 -0.096023151 -0.096023151 -0.096023151 + 12840 1.284 0.70006727 0.70006624 1.7260271e-07 -0.09603497 -0.09603497 -0.09603497 + 12850 1.285 0.70008834 0.70008727 1.9510818e-07 -0.096046754 -0.096046754 -0.096046754 + 12860 1.286 0.70010934 0.70010822 2.1286511e-07 -0.096058504 -0.096058504 -0.096058504 + 12870 1.287 0.70013028 0.70012911 2.2548613e-07 -0.09607022 -0.09607022 -0.09607022 + 12880 1.288 0.70015116 0.70014995 2.3270076e-07 -0.096081901 -0.096081901 -0.096081901 + 12890 1.289 0.70017198 0.70017071 2.343612e-07 -0.096093549 -0.096093549 -0.096093549 + 12900 1.29 0.70019274 0.70019142 2.3044536e-07 -0.096105162 -0.096105162 -0.096105162 + 12910 1.291 0.70021344 0.70021207 2.21057e-07 -0.096116742 -0.096116742 -0.096116742 + 12920 1.292 0.70023408 0.70023266 2.064231e-07 -0.096128288 -0.096128288 -0.096128288 + 12930 1.293 0.70025465 0.70025318 1.8688835e-07 -0.0961398 -0.0961398 -0.0961398 + 12940 1.294 0.70027516 0.70027366 1.6290711e-07 -0.096151279 -0.096151279 -0.096151279 + 12950 1.295 0.70029561 0.70029407 1.3503284e-07 -0.096162724 -0.096162724 -0.096162724 + 12960 1.296 0.70031599 0.70031442 1.0390534e-07 -0.096174135 -0.096174135 -0.096174135 + 12970 1.297 0.70033631 0.70033472 7.0236124e-08 -0.096185514 -0.096185514 -0.096185514 + 12980 1.298 0.70035657 0.70035497 3.4792111e-08 -0.096196859 -0.096196859 -0.096196859 + 12990 1.299 0.70037676 0.70037515 -1.621789e-09 -0.096208171 -0.096208171 -0.096208171 + 13000 1.3 0.70039689 0.70039529 -3.8180966e-08 -0.09621945 -0.09621945 -0.09621945 + 13010 1.301 0.70041696 0.70041536 -7.405977e-08 -0.096230697 -0.096230697 -0.096230697 + 13020 1.302 0.70043696 0.70043538 -1.0845016e-07 -0.09624191 -0.09624191 -0.09624191 + 13030 1.303 0.7004569 0.70045535 -1.4057989e-07 -0.096253091 -0.096253091 -0.096253091 + 13040 1.304 0.70047678 0.70047526 -1.6972986e-07 -0.096264239 -0.096264239 -0.096264239 + 13050 1.305 0.7004966 0.70049511 -1.952502e-07 -0.096275354 -0.096275354 -0.096275354 + 13060 1.306 0.70051635 0.70051491 -2.1657479e-07 -0.096286437 -0.096286437 -0.096286437 + 13070 1.307 0.70053605 0.70053465 -2.3323376e-07 -0.096297487 -0.096297487 -0.096297487 + 13080 1.308 0.70055569 0.70055434 -2.4486392e-07 -0.096308506 -0.096308506 -0.096308506 + 13090 1.309 0.70057526 0.70057396 -2.5121661e-07 -0.096319492 -0.096319492 -0.096319492 + 13100 1.31 0.70059478 0.70059353 -2.5216307e-07 -0.096330446 -0.096330446 -0.096330446 + 13110 1.311 0.70061425 0.70061305 -2.4769696e-07 -0.096341368 -0.096341368 -0.096341368 + 13120 1.312 0.70063365 0.7006325 -2.3793426e-07 -0.096352258 -0.096352258 -0.096352258 + 13130 1.313 0.700653 0.7006519 -2.2311023e-07 -0.096363116 -0.096363116 -0.096363116 + 13140 1.314 0.70067229 0.70067123 -2.0357386e-07 -0.096373942 -0.096373942 -0.096373942 + 13150 1.315 0.70069153 0.70069051 -1.7977963e-07 -0.096384737 -0.096384737 -0.096384737 + 13160 1.316 0.70071072 0.70070973 -1.5227697e-07 -0.0963955 -0.0963955 -0.0963955 + 13170 1.317 0.70072985 0.70072888 -1.2169761e-07 -0.096406232 -0.096406232 -0.096406232 + 13180 1.318 0.70074893 0.70074798 -8.8741043e-08 -0.096416932 -0.096416932 -0.096416932 + 13190 1.319 0.70076795 0.70076702 -5.4158599e-08 -0.096427601 -0.096427601 -0.096427601 + 13200 1.32 0.70078693 0.700786 -1.873627e-08 -0.096438239 -0.096438239 -0.096438239 + 13210 1.321 0.70080585 0.70080492 1.6723116e-08 -0.096448846 -0.096448846 -0.096448846 + 13220 1.322 0.70082472 0.70082377 5.1418091e-08 -0.096459421 -0.096459421 -0.096459421 + 13230 1.323 0.70084353 0.70084257 8.4566661e-08 -0.096469966 -0.096469966 -0.096469966 + 13240 1.324 0.7008623 0.70086131 1.1542392e-07 -0.09648048 -0.09648048 -0.09648048 + 13250 1.325 0.70088101 0.70087999 1.4329881e-07 -0.096490963 -0.096490963 -0.096490963 + 13260 1.326 0.70089967 0.70089862 1.6756957e-07 -0.096501415 -0.096501415 -0.096501415 + 13270 1.327 0.70091828 0.70091718 1.8769761e-07 -0.096511837 -0.096511837 -0.096511837 + 13280 1.328 0.70093683 0.70093569 2.032395e-07 -0.096522228 -0.096522228 -0.096522228 + 13290 1.329 0.70095533 0.70095415 2.1385668e-07 -0.096532589 -0.096532589 -0.096532589 + 13300 1.33 0.70097378 0.70097254 2.1932289e-07 -0.09654292 -0.09654292 -0.09654292 + 13310 1.331 0.70099217 0.70099089 2.1952893e-07 -0.09655322 -0.09655322 -0.09655322 + 13320 1.332 0.70101051 0.70100918 2.1448487e-07 -0.09656349 -0.09656349 -0.09656349 + 13330 1.333 0.70102879 0.70102741 2.0431946e-07 -0.09657373 -0.09657373 -0.09657373 + 13340 1.334 0.70104702 0.7010456 1.8927691e-07 -0.09658394 -0.09658394 -0.09658394 + 13350 1.335 0.70106519 0.70106373 1.6971105e-07 -0.09659412 -0.09659412 -0.09659412 + 13360 1.336 0.70108331 0.70108181 1.4607705e-07 -0.09660427 -0.09660427 -0.09660427 + 13370 1.337 0.70110137 0.70109984 1.1892082e-07 -0.096614391 -0.096614391 -0.096614391 + 13380 1.338 0.70111937 0.70111782 8.8866473e-08 -0.096624481 -0.096624481 -0.096624481 + 13390 1.339 0.70113732 0.70113574 5.6601919e-08 -0.096634542 -0.096634542 -0.096634542 + 13400 1.34 0.70115521 0.70115362 2.2863193e-08 -0.096644574 -0.096644574 -0.096644574 + 13410 1.341 0.70117304 0.70117145 -1.1582356e-08 -0.096654576 -0.096654576 -0.096654576 + 13420 1.342 0.70119082 0.70118924 -4.5953497e-08 -0.096664549 -0.096664549 -0.096664549 + 13430 1.343 0.70120854 0.70120697 -7.947284e-08 -0.096674493 -0.096674493 -0.096674493 + 13440 1.344 0.70122621 0.70122465 -1.1138441e-07 -0.096684408 -0.096684408 -0.096684408 + 13450 1.345 0.70124382 0.70124229 -1.4097069e-07 -0.096694293 -0.096694293 -0.096694293 + 13460 1.346 0.70126137 0.70125987 -1.6756876e-07 -0.096704149 -0.096704149 -0.096704149 + 13470 1.347 0.70127887 0.70127741 -1.9058516e-07 -0.096713977 -0.096713977 -0.096713977 + 13480 1.348 0.70129632 0.70129489 -2.095091e-07 -0.096723776 -0.096723776 -0.096723776 + 13490 1.349 0.70131371 0.70131233 -2.2392384e-07 -0.096733546 -0.096733546 -0.096733546 + 13500 1.35 0.70133105 0.70132971 -2.3351583e-07 -0.096743287 -0.096743287 -0.096743287 + 13510 1.351 0.70134834 0.70134705 -2.3808155e-07 -0.096752999 -0.096752999 -0.096752999 + 13520 1.352 0.70136557 0.70136433 -2.3753179e-07 -0.096762684 -0.096762684 -0.096762684 + 13530 1.353 0.70138276 0.70138157 -2.318934e-07 -0.096772339 -0.096772339 -0.096772339 + 13540 1.354 0.70139989 0.70139875 -2.2130834e-07 -0.096781967 -0.096781967 -0.096781967 + 13550 1.355 0.70141698 0.70141588 -2.0603016e-07 -0.096791566 -0.096791566 -0.096791566 + 13560 1.356 0.70143402 0.70143295 -1.8641795e-07 -0.096801137 -0.096801137 -0.096801137 + 13570 1.357 0.701451 0.70144997 -1.6292792e-07 -0.096810679 -0.096810679 -0.096810679 + 13580 1.358 0.70146795 0.70146695 -1.3610284e-07 -0.096820194 -0.096820194 -0.096820194 + 13590 1.359 0.70148484 0.70148386 -1.0655946e-07 -0.096829681 -0.096829681 -0.096829681 + 13600 1.36 0.70150169 0.70150073 -7.4974411e-08 -0.09683914 -0.09683914 -0.09683914 + 13610 1.361 0.70151849 0.70151754 -4.2068642e-08 -0.096848571 -0.096848571 -0.096848571 + 13620 1.362 0.70153524 0.70153429 -8.5910346e-09 -0.096857974 -0.096857974 -0.096857974 + 13630 1.363 0.70155195 0.701551 2.4698661e-08 -0.09686735 -0.09686735 -0.09686735 + 13640 1.364 0.70156861 0.70156765 5.7047056e-08 -0.096876699 -0.096876699 -0.096876699 + 13650 1.365 0.70158523 0.70158424 8.7724172e-08 -0.096886019 -0.096886019 -0.096886019 + 13660 1.366 0.7016018 0.70160079 1.1603991e-07 -0.096895313 -0.096895313 -0.096895313 + 13670 1.367 0.70161833 0.70161728 1.4135956e-07 -0.096904579 -0.096904579 -0.096904579 + 13680 1.368 0.7016348 0.70163373 1.6311807e-07 -0.096913817 -0.096913817 -0.096913817 + 13690 1.369 0.70165123 0.70165012 1.808326e-07 -0.096923029 -0.096923029 -0.096923029 + 13700 1.37 0.70166762 0.70166646 1.9411326e-07 -0.096932214 -0.096932214 -0.096932214 + 13710 1.371 0.70168396 0.70168275 2.0267172e-07 -0.096941371 -0.096941371 -0.096941371 + 13720 1.372 0.70170024 0.70169899 2.0632742e-07 -0.096950502 -0.096950502 -0.096950502 + 13730 1.373 0.70171648 0.70171519 2.0501137e-07 -0.096959606 -0.096959606 -0.096959606 + 13740 1.374 0.70173268 0.70173133 1.9876745e-07 -0.096968682 -0.096968682 -0.096968682 + 13750 1.375 0.70174882 0.70174743 1.8775106e-07 -0.096977733 -0.096977733 -0.096977733 + 13760 1.376 0.70176491 0.70176349 1.7222531e-07 -0.096986756 -0.096986756 -0.096986756 + 13770 1.377 0.70178096 0.70177949 1.5255477e-07 -0.096995753 -0.096995753 -0.096995753 + 13780 1.378 0.70179695 0.70179546 1.2919695e-07 -0.097004724 -0.097004724 -0.097004724 + 13790 1.379 0.7018129 0.70181137 1.026916e-07 -0.097013668 -0.097013668 -0.097013668 + 13800 1.38 0.70182879 0.70182725 7.3648346e-08 -0.097022586 -0.097022586 -0.097022586 + 13810 1.381 0.70184464 0.70184308 4.273262e-08 -0.097031478 -0.097031478 -0.097031478 + 13820 1.382 0.70186043 0.70185886 1.0650445e-08 -0.097040343 -0.097040343 -0.097040343 + 13830 1.383 0.70187617 0.7018746 -2.1867685e-08 -0.097049182 -0.097049182 -0.097049182 + 13840 1.384 0.70189187 0.7018903 -5.4083428e-08 -0.097057996 -0.097057996 -0.097057996 + 13850 1.385 0.70190751 0.70190596 -8.5267357e-08 -0.097066783 -0.097066783 -0.097066783 + 13860 1.386 0.7019231 0.70192157 -1.1471547e-07 -0.097075545 -0.097075545 -0.097075545 + 13870 1.387 0.70193865 0.70193714 -1.4176509e-07 -0.09708428 -0.09708428 -0.09708428 + 13880 1.388 0.70195414 0.70195267 -1.6580975e-07 -0.09709299 -0.09709299 -0.09709299 + 13890 1.389 0.70196959 0.70196815 -1.8631284e-07 -0.097101674 -0.097101674 -0.097101674 + 13900 1.39 0.70198499 0.70198359 -2.028195e-07 -0.097110333 -0.097110333 -0.097110333 + 13910 1.391 0.70200034 0.70199898 -2.1496682e-07 -0.097118966 -0.097118966 -0.097118966 + 13920 1.392 0.70201565 0.70201433 -2.2249171e-07 -0.097127574 -0.097127574 -0.097127574 + 13930 1.393 0.70203091 0.70202964 -2.2523667e-07 -0.097136156 -0.097136156 -0.097136156 + 13940 1.394 0.70204612 0.70204489 -2.2315301e-07 -0.097144713 -0.097144713 -0.097144713 + 13950 1.395 0.70206129 0.70206011 -2.1630171e-07 -0.097153245 -0.097153245 -0.097153245 + 13960 1.396 0.70207642 0.70207528 -2.048517e-07 -0.097161752 -0.097161752 -0.097161752 + 13970 1.397 0.7020915 0.7020904 -1.8907575e-07 -0.097170234 -0.097170234 -0.097170234 + 13980 1.398 0.70210654 0.70210547 -1.6934396e-07 -0.09717869 -0.09717869 -0.09717869 + 13990 1.399 0.70212153 0.7021205 -1.4611516e-07 -0.097187122 -0.097187122 -0.097187122 + 14000 1.4 0.70213649 0.70213548 -1.199262e-07 -0.097195529 -0.097195529 -0.097195529 + 14010 1.401 0.7021514 0.70215041 -9.1379589e-08 -0.097203911 -0.097203911 -0.097203911 + 14020 1.402 0.70216627 0.70216529 -6.1129618e-08 -0.097212268 -0.097212268 -0.097212268 + 14030 1.403 0.7021811 0.70218013 -2.9867402e-08 -0.097220601 -0.097220601 -0.097220601 + 14040 1.404 0.70219589 0.70219492 1.6949188e-09 -0.097228909 -0.097228909 -0.097228909 + 14050 1.405 0.70221064 0.70220966 3.2840391e-08 -0.097237192 -0.097237192 -0.097237192 + 14060 1.406 0.70222535 0.70222436 6.2863529e-08 -0.097245452 -0.097245452 -0.097245452 + 14070 1.407 0.70224002 0.70223901 9.1086294e-08 -0.097253686 -0.097253686 -0.097253686 + 14080 1.408 0.70225465 0.70225361 1.168734e-07 -0.097261897 -0.097261897 -0.097261897 + 14090 1.409 0.70226923 0.70226817 1.3964662e-07 -0.097270083 -0.097270083 -0.097270083 + 14100 1.41 0.70228378 0.70228268 1.5889773e-07 -0.097278245 -0.097278245 -0.097278245 + 14110 1.411 0.70229828 0.70229714 1.7419988e-07 -0.097286383 -0.097286383 -0.097286383 + 14120 1.412 0.70231275 0.70231157 1.8521704e-07 -0.097294497 -0.097294497 -0.097294497 + 14130 1.413 0.70232717 0.70232594 1.9171137e-07 -0.097302587 -0.097302587 -0.097302587 + 14140 1.414 0.70234155 0.70234028 1.9354835e-07 -0.097310653 -0.097310653 -0.097310653 + 14150 1.415 0.70235588 0.70235457 1.9069957e-07 -0.097318695 -0.097318695 -0.097318695 + 14160 1.416 0.70237017 0.70236882 1.8324303e-07 -0.097326714 -0.097326714 -0.097326714 + 14170 1.417 0.70238442 0.70238303 1.7136113e-07 -0.097334709 -0.097334709 -0.097334709 + 14180 1.418 0.70239863 0.70239719 1.5533621e-07 -0.09734268 -0.09734268 -0.09734268 + 14190 1.419 0.70241279 0.70241132 1.3554388e-07 -0.097350628 -0.097350628 -0.097350628 + 14200 1.42 0.7024269 0.70242541 1.1244419e-07 -0.097358552 -0.097358552 -0.097358552 + 14210 1.421 0.70244098 0.70243946 8.657102e-08 -0.097366453 -0.097366453 -0.097366453 + 14220 1.422 0.702455 0.70245347 5.8519701e-08 -0.097374331 -0.097374331 -0.097374331 + 14230 1.423 0.70246899 0.70246744 2.8933347e-08 -0.097382185 -0.097382185 -0.097382185 + 14240 1.424 0.70248292 0.70248137 -1.5118877e-09 -0.097390016 -0.097390016 -0.097390016 + 14250 1.425 0.70249682 0.70249526 -3.2122246e-08 -0.097397824 -0.097397824 -0.097397824 + 14260 1.426 0.70251067 0.70250912 -6.2202178e-08 -0.097405609 -0.097405609 -0.097405609 + 14270 1.427 0.70252447 0.70252294 -9.1070138e-08 -0.09741337 -0.09741337 -0.09741337 + 14280 1.428 0.70253823 0.70253672 -1.1807402e-07 -0.097421109 -0.097421109 -0.097421109 + 14290 1.429 0.70255195 0.70255046 -1.4260591e-07 -0.097428825 -0.097428825 -0.097428825 + 14300 1.43 0.70256562 0.70256416 -1.6411572e-07 -0.097436518 -0.097436518 -0.097436518 + 14310 1.431 0.70257925 0.70257783 -1.8212358e-07 -0.097444189 -0.097444189 -0.097444189 + 14320 1.432 0.70259284 0.70259145 -1.9623049e-07 -0.097451837 -0.097451837 -0.097451837 + 14330 1.433 0.70260638 0.70260504 -2.061272e-07 -0.097459462 -0.097459462 -0.097459462 + 14340 1.434 0.70261989 0.70261859 -2.1160096e-07 -0.097467064 -0.097467064 -0.097467064 + 14350 1.435 0.70263335 0.7026321 -2.1254009e-07 -0.097474645 -0.097474645 -0.097474645 + 14360 1.436 0.70264678 0.70264556 -2.0893625e-07 -0.097482202 -0.097482202 -0.097482202 + 14370 1.437 0.70266016 0.70265899 -2.0088431e-07 -0.097489738 -0.097489738 -0.097489738 + 14380 1.438 0.70267351 0.70267237 -1.8857993e-07 -0.097497251 -0.097497251 -0.097497251 + 14390 1.439 0.70268682 0.70268572 -1.7231485e-07 -0.097504742 -0.097504742 -0.097504742 + 14400 1.44 0.70270009 0.70269902 -1.5246993e-07 -0.09751221 -0.09751221 -0.09751221 + 14410 1.441 0.70271332 0.70271228 -1.2950634e-07 -0.097519657 -0.097519657 -0.097519657 + 14420 1.442 0.70272652 0.7027255 -1.0395477e-07 -0.097527081 -0.097527081 -0.097527081 + 14430 1.443 0.70273968 0.70273867 -7.6403244e-08 -0.097534484 -0.097534484 -0.097534484 + 14440 1.444 0.7027528 0.70275181 -4.7483544e-08 -0.097541865 -0.097541865 -0.097541865 + 14450 1.445 0.70276589 0.7027649 -1.7856769e-08 -0.097549223 -0.097549223 -0.097549223 + 14460 1.446 0.70277894 0.70277795 1.1801786e-08 -0.097556561 -0.097556561 -0.097556561 + 14470 1.447 0.70279195 0.70279095 4.0818017e-08 -0.097563876 -0.097563876 -0.097563876 + 14480 1.448 0.70280493 0.70280392 6.8534325e-08 -0.09757117 -0.09757117 -0.09757117 + 14490 1.449 0.70281788 0.70281684 9.4324517e-08 -0.097578442 -0.097578442 -0.097578442 + 14500 1.45 0.70283079 0.70282973 1.1760795e-07 -0.097585692 -0.097585692 -0.097585692 + 14510 1.451 0.70284366 0.70284257 1.3786261e-07 -0.097592921 -0.097592921 -0.097592921 + 14520 1.452 0.7028565 0.70285537 1.546368e-07 -0.097600129 -0.097600129 -0.097600129 + 14530 1.453 0.7028693 0.70286813 1.6755921e-07 -0.097607315 -0.097607315 -0.097607315 + 14540 1.454 0.70288206 0.70288086 1.7634715e-07 -0.09761448 -0.09761448 -0.09761448 + 14550 1.455 0.70289478 0.70289354 1.8081273e-07 -0.097621624 -0.097621624 -0.097621624 + 14560 1.456 0.70290747 0.70290619 1.8086683e-07 -0.097628747 -0.097628747 -0.097628747 + 14570 1.457 0.70292012 0.70291879 1.7652089e-07 -0.097635848 -0.097635848 -0.097635848 + 14580 1.458 0.70293273 0.70293137 1.6788635e-07 -0.097642929 -0.097642929 -0.097642929 + 14590 1.459 0.7029453 0.7029439 1.5517184e-07 -0.097649989 -0.097649989 -0.097649989 + 14600 1.46 0.70295784 0.7029564 1.3867815e-07 -0.097657027 -0.097657027 -0.097657027 + 14610 1.461 0.70297033 0.70296887 1.1879117e-07 -0.097664045 -0.097664045 -0.097664045 + 14620 1.462 0.70298279 0.7029813 9.5972821e-08 -0.097671042 -0.097671042 -0.097671042 + 14630 1.463 0.7029952 0.70299369 7.0750397e-08 -0.097678018 -0.097678018 -0.097678018 + 14640 1.464 0.70300758 0.70300605 4.3704347e-08 -0.097684974 -0.097684974 -0.097684974 + 14650 1.465 0.70301991 0.70301838 1.5454946e-08 -0.097691909 -0.097691909 -0.097691909 + 14660 1.466 0.70303221 0.70303067 -1.3351931e-08 -0.097698823 -0.097698823 -0.097698823 + 14670 1.467 0.70304446 0.70304293 -4.2059562e-08 -0.097705717 -0.097705717 -0.097705717 + 14680 1.468 0.70305668 0.70305516 -7.0015352e-08 -0.097712591 -0.097712591 -0.097712591 + 14690 1.469 0.70306886 0.70306735 -9.658566e-08 -0.097719444 -0.097719444 -0.097719444 + 14700 1.47 0.703081 0.70307951 -1.2117016e-07 -0.097726277 -0.097726277 -0.097726277 + 14710 1.471 0.7030931 0.70309163 -1.432154e-07 -0.097733089 -0.097733089 -0.097733089 + 14720 1.472 0.70310516 0.70310372 -1.6222726e-07 -0.097739882 -0.097739882 -0.097739882 + 14730 1.473 0.70311718 0.70311578 -1.7778203e-07 -0.097746654 -0.097746654 -0.097746654 + 14740 1.474 0.70312916 0.7031278 -1.8953585e-07 -0.097753406 -0.097753406 -0.097753406 + 14750 1.475 0.70314111 0.70313979 -1.9723228e-07 -0.097760138 -0.097760138 -0.097760138 + 14760 1.476 0.70315303 0.70315174 -2.0070795e-07 -0.09776685 -0.09776685 -0.09776685 + 14770 1.477 0.7031649 0.70316366 -1.9989595e-07 -0.097773542 -0.097773542 -0.097773542 + 14780 1.478 0.70317675 0.70317554 -1.9482712e-07 -0.097780215 -0.097780215 -0.097780215 + 14790 1.479 0.70318855 0.70318739 -1.8562905e-07 -0.097786867 -0.097786867 -0.097786867 + 14800 1.48 0.70320033 0.7031992 -1.7252294e-07 -0.0977935 -0.0977935 -0.0977935 + 14810 1.481 0.70321206 0.70321097 -1.5581824e-07 -0.097800113 -0.097800113 -0.097800113 + 14820 1.482 0.70322377 0.7032227 -1.3590543e-07 -0.097806707 -0.097806707 -0.097806707 + 14830 1.483 0.70323545 0.7032344 -1.1324688e-07 -0.097813281 -0.097813281 -0.097813281 + 14840 1.484 0.70324709 0.70324606 -8.8366093e-08 -0.097819835 -0.097819835 -0.097819835 + 14850 1.485 0.7032587 0.70325768 -6.1835671e-08 -0.09782637 -0.09782637 -0.09782637 + 14860 1.486 0.70327027 0.70326927 -3.4264114e-08 -0.097832886 -0.097832886 -0.097832886 + 14870 1.487 0.70328182 0.70328081 -6.2818816e-09 -0.097839382 -0.097839382 -0.097839382 + 14880 1.488 0.70329333 0.70329232 2.1473021e-08 -0.097845859 -0.097845859 -0.097845859 + 14890 1.489 0.70330482 0.7033038 4.8369582e-08 -0.097852317 -0.097852317 -0.097852317 + 14900 1.49 0.70331627 0.70331523 7.3798129e-08 -0.097858755 -0.097858755 -0.097858755 + 14910 1.491 0.70332769 0.70332663 9.718414e-08 -0.097865175 -0.097865175 -0.097865175 + 14920 1.492 0.70333908 0.70333799 1.1800123e-07 -0.097871575 -0.097871575 -0.097871575 + 14930 1.493 0.70335043 0.70334932 1.3578298e-07 -0.097877956 -0.097877956 -0.097877956 + 14940 1.494 0.70336176 0.70336061 1.501334e-07 -0.097884319 -0.097884319 -0.097884319 + 14950 1.495 0.70337305 0.70337187 1.6073576e-07 -0.097890662 -0.097890662 -0.097890662 + 14960 1.496 0.70338431 0.70338309 1.6735952e-07 -0.097896987 -0.097896987 -0.097896987 + 14970 1.497 0.70339554 0.70339427 1.6986541e-07 -0.097903293 -0.097903293 -0.097903293 + 14980 1.498 0.70340673 0.70340543 1.6820826e-07 -0.09790958 -0.09790958 -0.09790958 + 14990 1.499 0.70341789 0.70341655 1.6243785e-07 -0.097915849 -0.097915849 -0.097915849 + 15000 1.5 0.70342901 0.70342764 1.5269743e-07 -0.097922098 -0.097922098 -0.097922098 + 15010 1.501 0.7034401 0.70343869 1.3922024e-07 -0.09792833 -0.09792833 -0.09792833 + 15020 1.502 0.70345116 0.70344972 1.2232395e-07 -0.097934543 -0.097934543 -0.097934543 + 15030 1.503 0.70346218 0.70346071 1.0240314e-07 -0.097940737 -0.097940737 -0.097940737 + 15040 1.504 0.70347316 0.70347168 7.9920151e-08 -0.097946913 -0.097946913 -0.097946913 + 15050 1.505 0.70348411 0.70348261 5.5394328e-08 -0.09795307 -0.09795307 -0.09795307 + 15060 1.506 0.70349503 0.70349351 2.9390054e-08 -0.09795921 -0.09795921 -0.09795921 + 15070 1.507 0.70350591 0.70350438 2.5037625e-09 -0.097965331 -0.097965331 -0.097965331 + 15080 1.508 0.70351675 0.70351523 -2.4649737e-08 -0.097971434 -0.097971434 -0.097971434 + 15090 1.509 0.70352756 0.70352604 -5.145131e-08 -0.097977518 -0.097977518 -0.097977518 + 15100 1.51 0.70353833 0.70353683 -7.7291613e-08 -0.097983585 -0.097983585 -0.097983585 + 15110 1.511 0.70354907 0.70354758 -1.0158494e-07 -0.097989633 -0.097989633 -0.097989633 + 15120 1.512 0.70355978 0.70355831 -1.2378249e-07 -0.097995664 -0.097995664 -0.097995664 + 15130 1.513 0.70357044 0.703569 -1.4338479e-07 -0.098001677 -0.098001677 -0.098001677 + 15140 1.514 0.70358108 0.70357967 -1.5995288e-07 -0.098007671 -0.098007671 -0.098007671 + 15150 1.515 0.70359168 0.70359031 -1.731182e-07 -0.098013648 -0.098013648 -0.098013648 + 15160 1.516 0.70360225 0.70360091 -1.8259073e-07 -0.098019608 -0.098019608 -0.098019608 + 15170 1.517 0.70361279 0.70361149 -1.8816541e-07 -0.098025549 -0.098025549 -0.098025549 + 15180 1.518 0.7036233 0.70362203 -1.8972657e-07 -0.098031473 -0.098031473 -0.098031473 + 15190 1.519 0.70363377 0.70363254 -1.8725029e-07 -0.098037379 -0.098037379 -0.098037379 + 15200 1.52 0.70364421 0.70364302 -1.8080468e-07 -0.098043268 -0.098043268 -0.098043268 + 15210 1.521 0.70365462 0.70365347 -1.7054811e-07 -0.098049139 -0.098049139 -0.098049139 + 15220 1.522 0.70366501 0.70366388 -1.567253e-07 -0.098054992 -0.098054992 -0.098054992 + 15230 1.523 0.70367536 0.70367426 -1.3966151e-07 -0.098060828 -0.098060828 -0.098060828 + 15240 1.524 0.70368568 0.70368461 -1.1975493e-07 -0.098066647 -0.098066647 -0.098066647 + 15250 1.525 0.70369598 0.70369493 -9.7467355e-08 -0.098072449 -0.098072449 -0.098072449 + 15260 1.526 0.70370625 0.70370521 -7.3313509e-08 -0.098078233 -0.098078233 -0.098078233 + 15270 1.527 0.70371649 0.70371546 -4.7849162e-08 -0.098084 -0.098084 -0.098084 + 15280 1.528 0.7037267 0.70372568 -2.1658348e-08 -0.09808975 -0.09808975 -0.09808975 + 15290 1.529 0.70373688 0.70373586 4.6600242e-09 -0.098095483 -0.098095483 -0.098095483 + 15300 1.53 0.70374704 0.70374601 3.0505861e-08 -0.098101199 -0.098101199 -0.098101199 + 15310 1.531 0.70375717 0.70375612 5.5291564e-08 -0.098106897 -0.098106897 -0.098106897 + 15320 1.532 0.70376727 0.70376621 7.8455383e-08 -0.098112579 -0.098112579 -0.098112579 + 15330 1.533 0.70377734 0.70377626 9.9474145e-08 -0.098118244 -0.098118244 -0.098118244 + 15340 1.534 0.70378739 0.70378628 1.1787507e-07 -0.098123892 -0.098123892 -0.098123892 + 15350 1.535 0.7037974 0.70379626 1.3324639e-07 -0.098129523 -0.098129523 -0.098129523 + 15360 1.536 0.70380739 0.70380622 1.452466e-07 -0.098135137 -0.098135137 -0.098135137 + 15370 1.537 0.70381735 0.70381614 1.5361197e-07 -0.098140735 -0.098140735 -0.098140735 + 15380 1.538 0.70382728 0.70382604 1.581624e-07 -0.098146316 -0.098146316 -0.098146316 + 15390 1.539 0.70383718 0.7038359 1.5880528e-07 -0.09815188 -0.09815188 -0.09815188 + 15400 1.54 0.70384705 0.70384574 1.555373e-07 -0.098157428 -0.098157428 -0.098157428 + 15410 1.541 0.70385689 0.70385554 1.4844432e-07 -0.098162959 -0.098162959 -0.098162959 + 15420 1.542 0.7038667 0.70386532 1.3769916e-07 -0.098168474 -0.098168474 -0.098168474 + 15430 1.543 0.70387648 0.70387507 1.2355736e-07 -0.098173973 -0.098173973 -0.098173973 + 15440 1.544 0.70388623 0.70388479 1.0635119e-07 -0.098179455 -0.098179455 -0.098179455 + 15450 1.545 0.70389595 0.70389449 8.6481803e-08 -0.09818492 -0.09818492 -0.09818492 + 15460 1.546 0.70390564 0.70390415 6.4409912e-08 -0.09819037 -0.09819037 -0.09819037 + 15470 1.547 0.70391529 0.7039138 4.0645117e-08 -0.098195803 -0.098195803 -0.098195803 + 15480 1.548 0.70392492 0.70392341 1.5734144e-08 -0.09820122 -0.09820122 -0.09820122 + 15490 1.549 0.70393451 0.703933 -9.7517264e-09 -0.098206621 -0.098206621 -0.098206621 + 15500 1.55 0.70394407 0.70394256 -3.5229752e-08 -0.098212005 -0.098212005 -0.098212005 + 15510 1.551 0.7039536 0.7039521 -6.0119051e-08 -0.098217374 -0.098217374 -0.098217374 + 15520 1.552 0.7039631 0.70396161 -8.3853843e-08 -0.098222727 -0.098222727 -0.098222727 + 15530 1.553 0.70397256 0.7039711 -1.058963e-07 -0.098228064 -0.098228064 -0.098228064 + 15540 1.554 0.703982 0.70398056 -1.2574875e-07 -0.098233384 -0.098233384 -0.098233384 + 15550 1.555 0.70399141 0.70398999 -1.4296488e-07 -0.098238689 -0.098238689 -0.098238689 + 15560 1.556 0.70400079 0.7039994 -1.5715979e-07 -0.098243979 -0.098243979 -0.098243979 + 15570 1.557 0.70401013 0.70400878 -1.6801858e-07 -0.098249252 -0.098249252 -0.098249252 + 15580 1.558 0.70401945 0.70401813 -1.7530336e-07 -0.09825451 -0.09825451 -0.09825451 + 15590 1.559 0.70402874 0.70402745 -1.7885842e-07 -0.098259752 -0.098259752 -0.098259752 + 15600 1.56 0.704038 0.70403675 -1.7861355e-07 -0.098264978 -0.098264978 -0.098264978 + 15610 1.561 0.70404724 0.70404602 -1.7458543e-07 -0.098270189 -0.098270189 -0.098270189 + 15620 1.562 0.70405644 0.70405526 -1.6687696e-07 -0.098275384 -0.098275384 -0.098275384 + 15630 1.563 0.70406562 0.70406447 -1.5567469e-07 -0.098280564 -0.098280564 -0.098280564 + 15640 1.564 0.70407478 0.70407366 -1.4124432e-07 -0.098285728 -0.098285728 -0.098285728 + 15650 1.565 0.70408391 0.70408281 -1.2392441e-07 -0.098290877 -0.098290877 -0.098290877 + 15660 1.566 0.70409301 0.70409194 -1.0411845e-07 -0.098296011 -0.098296011 -0.098296011 + 15670 1.567 0.70410209 0.70410103 -8.228546e-08 -0.098301129 -0.098301129 -0.098301129 + 15680 1.568 0.70411114 0.7041101 -5.8929393e-08 -0.098306232 -0.098306232 -0.098306232 + 15690 1.569 0.70412017 0.70411913 -3.4587472e-08 -0.09831132 -0.09831132 -0.09831132 + 15700 1.57 0.70412918 0.70412814 -9.8178579e-09 -0.098316392 -0.098316392 -0.098316392 + 15710 1.571 0.70413816 0.70413712 1.4813146e-08 -0.09832145 -0.09832145 -0.09832145 + 15720 1.572 0.70414711 0.70414606 3.8744037e-08 -0.098326492 -0.098326492 -0.098326492 + 15730 1.573 0.70415604 0.70415498 6.143091e-08 -0.09833152 -0.09833152 -0.09833152 + 15740 1.574 0.70416495 0.70416387 8.2359818e-08 -0.098336532 -0.098336532 -0.098336532 + 15750 1.575 0.70417383 0.70417273 1.0105841e-07 -0.098341529 -0.098341529 -0.098341529 + 15760 1.576 0.70418269 0.70418156 1.1710658e-07 -0.098346512 -0.098346512 -0.098346512 + 15770 1.577 0.70419153 0.70419036 1.3014592e-07 -0.098351479 -0.098351479 -0.098351479 + 15780 1.578 0.70420033 0.70419914 1.3988771e-07 -0.098356432 -0.098356432 -0.098356432 + 15790 1.579 0.70420912 0.70420789 1.461193e-07 -0.09836137 -0.09836137 -0.09836137 + 15800 1.58 0.70421787 0.70421661 1.4870876e-07 -0.098366294 -0.098366294 -0.098366294 + 15810 1.581 0.7042266 0.70422531 1.4760765e-07 -0.098371202 -0.098371202 -0.098371202 + 15820 1.582 0.70423531 0.70423398 1.4285187e-07 -0.098376096 -0.098376096 -0.098376096 + 15830 1.583 0.70424398 0.70424262 1.3456062e-07 -0.098380975 -0.098380975 -0.098380975 + 15840 1.584 0.70425263 0.70425124 1.2293345e-07 -0.09838584 -0.09838584 -0.09838584 + 15850 1.585 0.70426126 0.70425984 1.0824544e-07 -0.09839069 -0.09839069 -0.09839069 + 15860 1.586 0.70426985 0.70426841 9.0840722e-08 -0.098395526 -0.098395526 -0.098395526 + 15870 1.587 0.70427842 0.70427696 7.1124441e-08 -0.098400347 -0.098400347 -0.098400347 + 15880 1.588 0.70428696 0.70428548 4.9553316e-08 -0.098405154 -0.098405154 -0.098405154 + 15890 1.589 0.70429547 0.70429398 2.6625073e-08 -0.098409947 -0.098409947 -0.098409947 + 15900 1.59 0.70430395 0.70430246 2.8669696e-09 -0.098414725 -0.098414725 -0.098414725 + 15910 1.591 0.70431241 0.70431091 -2.1176328e-08 -0.098419489 -0.098419489 -0.098419489 + 15920 1.592 0.70432084 0.70431935 -4.4955223e-08 -0.098424239 -0.098424239 -0.098424239 + 15930 1.593 0.70432924 0.70432776 -6.792775e-08 -0.098428975 -0.098428975 -0.098428975 + 15940 1.594 0.70433761 0.70433614 -8.9571923e-08 -0.098433696 -0.098433696 -0.098433696 + 15950 1.595 0.70434595 0.70434451 -1.0939759e-07 -0.098438403 -0.098438403 -0.098438403 + 15960 1.596 0.70435427 0.70435285 -1.2695754e-07 -0.098443097 -0.098443097 -0.098443097 + 15970 1.597 0.70436256 0.70436116 -1.4185757e-07 -0.098447776 -0.098447776 -0.098447776 + 15980 1.598 0.70437083 0.70436946 -1.5376534e-07 -0.098452441 -0.098452441 -0.098452441 + 15990 1.599 0.70437907 0.70437773 -1.624178e-07 -0.098457093 -0.098457093 -0.098457093 + 16000 1.6 0.70438728 0.70438597 -1.6762696e-07 -0.09846173 -0.09846173 -0.09846173 + 16010 1.601 0.70439547 0.7043942 -1.6928399e-07 -0.098466354 -0.098466354 -0.098466354 + 16020 1.602 0.70440363 0.70440239 -1.6736147e-07 -0.098470963 -0.098470963 -0.098470963 + 16030 1.603 0.70441177 0.70441057 -1.6191378e-07 -0.098475559 -0.098475559 -0.098475559 + 16040 1.604 0.70441989 0.70441871 -1.5307563e-07 -0.098480142 -0.098480142 -0.098480142 + 16050 1.605 0.70442798 0.70442683 -1.4105875e-07 -0.09848471 -0.09848471 -0.09848471 + 16060 1.606 0.70443605 0.70443493 -1.2614681e-07 -0.098489265 -0.098489265 -0.098489265 + 16070 1.607 0.7044441 0.704443 -1.0868876e-07 -0.098493807 -0.098493807 -0.098493807 + 16080 1.608 0.70445212 0.70445104 -8.9090701e-08 -0.098498334 -0.098498334 -0.098498334 + 16090 1.609 0.70446013 0.70445906 -6.7806377e-08 -0.098502849 -0.098502849 -0.098502849 + 16100 1.61 0.70446811 0.70446705 -4.5326735e-08 -0.098507349 -0.098507349 -0.098507349 + 16110 1.611 0.70447607 0.70447502 -2.2168584e-08 -0.098511837 -0.098511837 -0.098511837 + 16120 1.612 0.70448401 0.70448295 1.1372758e-09 -0.098516311 -0.098516311 -0.098516311 + 16130 1.613 0.70449193 0.70449087 2.4058218e-08 -0.098520771 -0.098520771 -0.098520771 + 16140 1.614 0.70449982 0.70449875 4.6071956e-08 -0.098525218 -0.098525218 -0.098525218 + 16150 1.615 0.7045077 0.70450661 6.6678439e-08 -0.098529652 -0.098529652 -0.098529652 + 16160 1.616 0.70451555 0.70451445 8.5411213e-08 -0.098534073 -0.098534073 -0.098534073 + 16170 1.617 0.70452338 0.70452225 1.0184797e-07 -0.09853848 -0.09853848 -0.09853848 + 16180 1.618 0.70453119 0.70453004 1.1562006e-07 -0.098542874 -0.098542874 -0.098542874 + 16190 1.619 0.70453898 0.7045378 1.2642079e-07 -0.098547256 -0.098547256 -0.098547256 + 16200 1.62 0.70454674 0.70454553 1.3401219e-07 -0.098551624 -0.098551624 -0.098551624 + 16210 1.621 0.70455449 0.70455324 1.382303e-07 -0.098555978 -0.098555978 -0.098555978 + 16220 1.622 0.70456221 0.70456093 1.3898867e-07 -0.09856032 -0.09856032 -0.09856032 + 16230 1.623 0.7045699 0.70456859 1.3628015e-07 -0.098564649 -0.098564649 -0.098564649 + 16240 1.624 0.70457758 0.70457623 1.3017678e-07 -0.098568965 -0.098568965 -0.098568965 + 16250 1.625 0.70458522 0.70458385 1.2082792e-07 -0.098573268 -0.098573268 -0.098573268 + 16260 1.626 0.70459285 0.70459145 1.0845664e-07 -0.098577559 -0.098577559 -0.098577559 + 16270 1.627 0.70460045 0.70459903 9.3354414e-08 -0.098581836 -0.098581836 -0.098581836 + 16280 1.628 0.70460803 0.70460658 7.5874224e-08 -0.098586101 -0.098586101 -0.098586101 + 16290 1.629 0.70461558 0.70461412 5.6422355e-08 -0.098590352 -0.098590352 -0.098590352 + 16300 1.63 0.7046231 0.70462163 3.5448945e-08 -0.098594591 -0.098594591 -0.098594591 + 16310 1.631 0.70463061 0.70462913 1.3437578e-08 -0.098598818 -0.098598818 -0.098598818 + 16320 1.632 0.70463808 0.7046366 -9.1058606e-09 -0.098603032 -0.098603032 -0.098603032 + 16330 1.633 0.70464553 0.70464405 -3.1664807e-08 -0.098607233 -0.098607233 -0.098607233 + 16340 1.634 0.70465296 0.70465149 -5.372385e-08 -0.098611421 -0.098611421 -0.098611421 + 16350 1.635 0.70466036 0.7046589 -7.4780503e-08 -0.098615598 -0.098615598 -0.098615598 + 16360 1.636 0.70466774 0.7046663 -9.4356646e-08 -0.098619761 -0.098619761 -0.098619761 + 16370 1.637 0.7046751 0.70467367 -1.1200938e-07 -0.098623912 -0.098623912 -0.098623912 + 16380 1.638 0.70468243 0.70468102 -1.2734106e-07 -0.098628051 -0.098628051 -0.098628051 + 16390 1.639 0.70468973 0.70468836 -1.4000819e-07 -0.098632177 -0.098632177 -0.098632177 + 16400 1.64 0.70469702 0.70469567 -1.4972922e-07 -0.098636291 -0.098636291 -0.098636291 + 16410 1.641 0.70470428 0.70470296 -1.5629068e-07 -0.098640393 -0.098640393 -0.098640393 + 16420 1.642 0.70471152 0.70471023 -1.5955195e-07 -0.098644482 -0.098644482 -0.098644482 + 16430 1.643 0.70471873 0.70471748 -1.5944822e-07 -0.098648559 -0.098648559 -0.098648559 + 16440 1.644 0.70472593 0.7047247 -1.5599177e-07 -0.098652624 -0.098652624 -0.098652624 + 16450 1.645 0.7047331 0.70473191 -1.4927144e-07 -0.098656677 -0.098656677 -0.098656677 + 16460 1.646 0.70474025 0.70473909 -1.3945041e-07 -0.098660718 -0.098660718 -0.098660718 + 16470 1.647 0.70474739 0.70474624 -1.2676223e-07 -0.098664746 -0.098664746 -0.098664746 + 16480 1.648 0.7047545 0.70475338 -1.115053e-07 -0.098668763 -0.098668763 -0.098668763 + 16490 1.649 0.70476159 0.70476049 -9.4035824e-08 -0.098672767 -0.098672767 -0.098672767 + 16500 1.65 0.70476867 0.70476758 -7.475956e-08 -0.09867676 -0.09867676 -0.09867676 + 16510 1.651 0.70477572 0.70477465 -5.4122352e-08 -0.09868074 -0.09868074 -0.09868074 + 16520 1.652 0.70478276 0.70478169 -3.259985e-08 -0.098684709 -0.098684709 -0.098684709 + 16530 1.653 0.70478977 0.70478871 -1.0686544e-08 -0.098688666 -0.098688666 -0.098688666 + 16540 1.654 0.70479677 0.7047957 1.111559e-08 -0.098692611 -0.098692611 -0.098692611 + 16550 1.655 0.70480375 0.70480267 3.2308584e-08 -0.098696544 -0.098696544 -0.098696544 + 16560 1.656 0.70481071 0.70480962 5.2409852e-08 -0.098700465 -0.098700465 -0.098700465 + 16570 1.657 0.70481765 0.70481655 7.096317e-08 -0.098704374 -0.098704374 -0.098704374 + 16580 1.658 0.70482458 0.70482345 8.7549031e-08 -0.098708272 -0.098708272 -0.098708272 + 16590 1.659 0.70483148 0.70483033 1.0179413e-07 -0.098712158 -0.098712158 -0.098712158 + 16600 1.66 0.70483837 0.70483719 1.1337974e-07 -0.098716033 -0.098716033 -0.098716033 + 16610 1.661 0.70484523 0.70484403 1.2204889e-07 -0.098719896 -0.098719896 -0.098719896 + 16620 1.662 0.70485208 0.70485084 1.27612e-07 -0.098723747 -0.098723747 -0.098723747 + 16630 1.663 0.7048589 0.70485764 1.2995106e-07 -0.098727587 -0.098727587 -0.098727587 + 16640 1.664 0.7048657 0.70486441 1.290221e-07 -0.098731415 -0.098731415 -0.098731415 + 16650 1.665 0.70487249 0.70487117 1.2485598e-07 -0.098735232 -0.098735232 -0.098735232 + 16660 1.666 0.70487925 0.7048779 1.1755749e-07 -0.098739038 -0.098739038 -0.098739038 + 16670 1.667 0.70488599 0.70488461 1.0730269e-07 -0.098742832 -0.098742832 -0.098742832 + 16680 1.668 0.70489271 0.70489131 9.4334741e-08 -0.098746614 -0.098746614 -0.098746614 + 16690 1.669 0.70489941 0.70489799 7.89581e-08 -0.098750386 -0.098750386 -0.098750386 + 16700 1.67 0.70490609 0.70490465 6.1531405e-08 -0.098754146 -0.098754146 -0.098754146 + 16710 1.671 0.70491274 0.70491129 4.2459112e-08 -0.098757894 -0.098757894 -0.098757894 + 16720 1.672 0.70491938 0.70491791 2.2182113e-08 -0.098761632 -0.098761632 -0.098761632 + 16730 1.673 0.70492599 0.70492452 1.1675535e-09 -0.098765358 -0.098765358 -0.098765358 + 16740 1.674 0.70493257 0.7049311 -2.0101928e-08 -0.098769073 -0.098769073 -0.098769073 + 16750 1.675 0.70493914 0.70493767 -4.113928e-08 -0.098772777 -0.098772777 -0.098772777 + 16760 1.676 0.70494568 0.70494423 -6.1464185e-08 -0.09877647 -0.09877647 -0.09877647 + 16770 1.677 0.70495221 0.70495076 -8.0614024e-08 -0.098780152 -0.098780152 -0.098780152 + 16780 1.678 0.70495871 0.70495728 -9.8154404e-08 -0.098783823 -0.098783823 -0.098783823 + 16790 1.679 0.70496519 0.70496378 -1.1368901e-07 -0.098787483 -0.098787483 -0.098787483 + 16800 1.68 0.70497165 0.70497026 -1.2686854e-07 -0.098791132 -0.098791132 -0.098791132 + 16810 1.681 0.70497808 0.70497672 -1.3739859e-07 -0.09879477 -0.09879477 -0.09879477 + 16820 1.682 0.7049845 0.70498317 -1.4504619e-07 -0.098798397 -0.098798397 -0.098798397 + 16830 1.683 0.7049909 0.7049896 -1.4964497e-07 -0.098802013 -0.098802013 -0.098802013 + 16840 1.684 0.70499728 0.704996 -1.5109878e-07 -0.098805618 -0.098805618 -0.098805618 + 16850 1.685 0.70500363 0.70500239 -1.4938365e-07 -0.098809212 -0.098809212 -0.098809212 + 16860 1.686 0.70500997 0.70500876 -1.4454818e-07 -0.098812796 -0.098812796 -0.098812796 + 16870 1.687 0.7050163 0.70501511 -1.3671215e-07 -0.098816369 -0.098816369 -0.098816369 + 16880 1.688 0.7050226 0.70502144 -1.2606364e-07 -0.098819931 -0.098819931 -0.098819931 + 16890 1.689 0.70502888 0.70502775 -1.1285449e-07 -0.098823483 -0.098823483 -0.098823483 + 16900 1.69 0.70503515 0.70503403 -9.7394347e-08 -0.098827024 -0.098827024 -0.098827024 + 16910 1.691 0.7050414 0.7050403 -8.0043457e-08 -0.098830554 -0.098830554 -0.098830554 + 16920 1.692 0.70504764 0.70504655 -6.1204235e-08 -0.098834074 -0.098834074 -0.098834074 + 16930 1.693 0.70505386 0.70505277 -4.1311958e-08 -0.098837583 -0.098837583 -0.098837583 + 16940 1.694 0.70506006 0.70505898 -2.0824711e-08 -0.098841082 -0.098841082 -0.098841082 + 16950 1.695 0.70506624 0.70506516 -2.128402e-10 -0.09884457 -0.09884457 -0.09884457 + 16960 1.696 0.70507241 0.70507132 2.0051838e-08 -0.098848048 -0.098848048 -0.098848048 + 16970 1.697 0.70507856 0.70507747 3.9506835e-08 -0.098851515 -0.098851515 -0.098851515 + 16980 1.698 0.7050847 0.70508359 5.7709542e-08 -0.098854972 -0.098854972 -0.098854972 + 16990 1.699 0.70509082 0.70508969 7.4247296e-08 -0.098858418 -0.098858418 -0.098858418 + 17000 1.7 0.70509692 0.70509577 8.8746729e-08 -0.098861854 -0.098861854 -0.098861854 + 17010 1.701 0.705103 0.70510183 1.008822e-07 -0.09886528 -0.09886528 -0.09886528 + 17020 1.702 0.70510907 0.70510788 1.103831e-07 -0.098868696 -0.098868696 -0.098868696 + 17030 1.703 0.70511512 0.7051139 1.1703987e-07 -0.098872101 -0.098872101 -0.098872101 + 17040 1.704 0.70512115 0.7051199 1.2070866e-07 -0.098875496 -0.098875496 -0.098875496 + 17050 1.705 0.70512717 0.70512589 1.2131436e-07 -0.098878881 -0.098878881 -0.098878881 + 17060 1.706 0.70513317 0.70513186 1.1885218e-07 -0.098882256 -0.098882256 -0.098882256 + 17070 1.707 0.70513915 0.70513781 1.1338751e-07 -0.098885621 -0.098885621 -0.098885621 + 17080 1.708 0.7051451 0.70514374 1.0505425e-07 -0.098888975 -0.098888975 -0.098888975 + 17090 1.709 0.70515105 0.70514966 9.4051537e-08 -0.09889232 -0.09889232 -0.09889232 + 17100 1.71 0.70515697 0.70515556 8.0638973e-08 -0.098895654 -0.098895654 -0.098895654 + 17110 1.711 0.70516287 0.70516145 6.5130548e-08 -0.098898978 -0.098898978 -0.098898978 + 17120 1.712 0.70516875 0.70516731 4.7887273e-08 -0.098902293 -0.098902293 -0.098902293 + 17130 1.713 0.70517462 0.70517317 2.930879e-08 -0.098905597 -0.098905597 -0.098905597 + 17140 1.714 0.70518046 0.705179 9.8241129e-09 -0.098908892 -0.098908892 -0.098908892 + 17150 1.715 0.70518628 0.70518482 -1.0118272e-08 -0.098912177 -0.098912177 -0.098912177 + 17160 1.716 0.70519209 0.70519063 -3.0060726e-08 -0.098915452 -0.098915452 -0.098915452 + 17170 1.717 0.70519787 0.70519642 -4.9546956e-08 -0.098918717 -0.098918717 -0.098918717 + 17180 1.718 0.70520364 0.7052022 -6.8132453e-08 -0.098921972 -0.098921972 -0.098921972 + 17190 1.719 0.70520938 0.70520796 -8.5394625e-08 -0.098925217 -0.098925217 -0.098925217 + 17200 1.72 0.70521511 0.7052137 -1.009424e-07 -0.098928453 -0.098928453 -0.098928453 + 17210 1.721 0.70522082 0.70521943 -1.144251e-07 -0.098931679 -0.098931679 -0.098931679 + 17220 1.722 0.70522651 0.70522514 -1.2554032e-07 -0.098934896 -0.098934896 -0.098934896 + 17230 1.723 0.70523218 0.70523084 -1.3404073e-07 -0.098938102 -0.098938102 -0.098938102 + 17240 1.724 0.70523783 0.70523652 -1.3973956e-07 -0.098941299 -0.098941299 -0.098941299 + 17250 1.725 0.70524347 0.70524218 -1.4251469e-07 -0.098944487 -0.098944487 -0.098944487 + 17260 1.726 0.70524909 0.70524783 -1.4231129e-07 -0.098947665 -0.098947665 -0.098947665 + 17270 1.727 0.70525469 0.70525346 -1.3914283e-07 -0.098950833 -0.098950833 -0.098950833 + 17280 1.728 0.70526027 0.70525907 -1.3309062e-07 -0.098953992 -0.098953992 -0.098953992 + 17290 1.729 0.70526584 0.70526466 -1.243017e-07 -0.098957141 -0.098957141 -0.098957141 + 17300 1.73 0.7052714 0.70527024 -1.1298532e-07 -0.098960281 -0.098960281 -0.098960281 + 17310 1.731 0.70527694 0.7052758 -9.9407949e-08 -0.098963411 -0.098963411 -0.098963411 + 17320 1.732 0.70528246 0.70528134 -8.3887032e-08 -0.098966533 -0.098966533 -0.098966533 + 17330 1.733 0.70528797 0.70528686 -6.6783544e-08 -0.098969644 -0.098969644 -0.098969644 + 17340 1.734 0.70529346 0.70529236 -4.8493623e-08 -0.098972747 -0.098972747 -0.098972747 + 17350 1.735 0.70529894 0.70529785 -2.9439391e-08 -0.09897584 -0.09897584 -0.09897584 + 17360 1.736 0.70530441 0.70530332 -1.0059218e-08 -0.098978923 -0.098978923 -0.098978923 + 17370 1.737 0.70530986 0.70530876 9.2023572e-09 -0.098981998 -0.098981998 -0.098981998 + 17380 1.738 0.70531529 0.70531419 2.7904822e-08 -0.098985063 -0.098985063 -0.098985063 + 17390 1.739 0.70532071 0.7053196 4.5621759e-08 -0.098988119 -0.098988119 -0.098988119 + 17400 1.74 0.70532612 0.705325 6.1950569e-08 -0.098991166 -0.098991166 -0.098991166 + 17410 1.741 0.70533151 0.70533037 7.6521611e-08 -0.098994204 -0.098994204 -0.098994204 + 17420 1.742 0.70533689 0.70533573 8.9006571e-08 -0.098997232 -0.098997232 -0.098997232 + 17430 1.743 0.70534225 0.70534107 9.9125854e-08 -0.099000252 -0.099000252 -0.099000252 + 17440 1.744 0.7053476 0.70534639 1.0665484e-07 -0.099003262 -0.099003262 -0.099003262 + 17450 1.745 0.70535293 0.7053517 1.1142887e-07 -0.099006264 -0.099006264 -0.099006264 + 17460 1.746 0.70535825 0.70535699 1.1334683e-07 -0.099009256 -0.099009256 -0.099009256 + 17470 1.747 0.70536355 0.70536226 1.1237329e-07 -0.099012239 -0.099012239 -0.099012239 + 17480 1.748 0.70536884 0.70536752 1.085391e-07 -0.099015214 -0.099015214 -0.099015214 + 17490 1.749 0.7053741 0.70537276 1.0194053e-07 -0.099018179 -0.099018179 -0.099018179 + 17500 1.75 0.70537936 0.70537799 9.2736828e-08 -0.099021136 -0.099021136 -0.099021136 + 17510 1.751 0.70538459 0.7053832 8.1146424e-08 -0.099024084 -0.099024084 -0.099024084 + 17520 1.752 0.70538981 0.7053884 6.7441735e-08 -0.099027023 -0.099027023 -0.099027023 + 17530 1.753 0.70539501 0.70539358 5.1942781e-08 -0.099029953 -0.099029953 -0.099029953 + 17540 1.754 0.70540019 0.70539875 3.500971e-08 -0.099032874 -0.099032874 -0.099032874 + 17550 1.755 0.70540535 0.70540391 1.7034444e-08 -0.099035786 -0.099035786 -0.099035786 + 17560 1.756 0.7054105 0.70540906 -1.5683958e-09 -0.09903869 -0.09903869 -0.09903869 + 17570 1.757 0.70541563 0.70541419 -2.0371043e-08 -0.099041585 -0.099041585 -0.099041585 + 17580 1.758 0.70542074 0.7054193 -3.894242e-08 -0.099044471 -0.099044471 -0.099044471 + 17590 1.759 0.70542584 0.7054244 -5.685802e-08 -0.099047349 -0.099047349 -0.099047349 + 17600 1.76 0.70543092 0.70542949 -7.3709601e-08 -0.099050218 -0.099050218 -0.099050218 + 17610 1.761 0.70543598 0.70543457 -8.9114493e-08 -0.099053078 -0.099053078 -0.099053078 + 17620 1.762 0.70544102 0.70543963 -1.0272428e-07 -0.09905593 -0.09905593 -0.09905593 + 17630 1.763 0.70544605 0.70544468 -1.1423268e-07 -0.099058773 -0.099058773 -0.099058773 + 17640 1.764 0.70545106 0.70544972 -1.2338242e-07 -0.099061607 -0.099061607 -0.099061607 + 17650 1.765 0.70545606 0.70545474 -1.2997101e-07 -0.099064433 -0.099064433 -0.099064433 + 17660 1.766 0.70546104 0.70545974 -1.3385519e-07 -0.099067251 -0.099067251 -0.099067251 + 17670 1.767 0.705466 0.70546473 -1.3495407e-07 -0.09907006 -0.09907006 -0.09907006 + 17680 1.768 0.70547095 0.70546971 -1.3325075e-07 -0.099072861 -0.099072861 -0.099072861 + 17690 1.769 0.70547589 0.70547467 -1.2879257e-07 -0.099075653 -0.099075653 -0.099075653 + 17700 1.77 0.70548081 0.70547961 -1.216898e-07 -0.099078437 -0.099078437 -0.099078437 + 17710 1.771 0.70548571 0.70548454 -1.1211294e-07 -0.099081212 -0.099081212 -0.099081212 + 17720 1.772 0.70549061 0.70548945 -1.0028866e-07 -0.09908398 -0.09908398 -0.09908398 + 17730 1.773 0.70549549 0.70549435 -8.6494411e-08 -0.099086738 -0.099086738 -0.099086738 + 17740 1.774 0.70550035 0.70549923 -7.1051936e-08 -0.099089489 -0.099089489 -0.099089489 + 17750 1.775 0.70550521 0.7055041 -5.4319777e-08 -0.099092231 -0.099092231 -0.099092231 + 17760 1.776 0.70551005 0.70550894 -3.6684948e-08 -0.099094965 -0.099094965 -0.099094965 + 17770 1.777 0.70551488 0.70551377 -1.855399e-08 -0.099097691 -0.099097691 -0.099097691 + 17780 1.778 0.70551969 0.70551859 -3.4360344e-10 -0.099100409 -0.099100409 -0.099100409 + 17790 1.779 0.70552449 0.70552339 1.7528926e-08 -0.099103118 -0.099103118 -0.099103118 + 17800 1.78 0.70552928 0.70552817 3.4655283e-08 -0.099105819 -0.099105819 -0.099105819 + 17810 1.781 0.70553406 0.70553293 5.0645452e-08 -0.099108513 -0.099108513 -0.099108513 + 17820 1.782 0.70553883 0.70553768 6.5136593e-08 -0.099111198 -0.099111198 -0.099111198 + 17830 1.783 0.70554358 0.70554242 7.7801273e-08 -0.099113875 -0.099113875 -0.099113875 + 17840 1.784 0.70554832 0.70554714 8.8354857e-08 -0.099116544 -0.099116544 -0.099116544 + 17850 1.785 0.70555304 0.70555184 9.6561908e-08 -0.099119205 -0.099119205 -0.099119205 + 17860 1.786 0.70555776 0.70555653 1.0224143e-07 -0.099121857 -0.099121857 -0.099121857 + 17870 1.787 0.70556246 0.7055612 1.0527086e-07 -0.099124502 -0.099124502 -0.099124502 + 17880 1.788 0.70556714 0.70556586 1.0558868e-07 -0.099127139 -0.099127139 -0.099127139 + 17890 1.789 0.70557181 0.7055705 1.0319568e-07 -0.099129768 -0.099129768 -0.099129768 + 17900 1.79 0.70557647 0.70557514 9.8154728e-08 -0.09913239 -0.09913239 -0.09913239 + 17910 1.791 0.70558111 0.70557975 9.0589173e-08 -0.099135003 -0.099135003 -0.099135003 + 17920 1.792 0.70558573 0.70558436 8.0679815e-08 -0.099137608 -0.099137608 -0.099137608 + 17930 1.793 0.70559034 0.70558895 6.8660607e-08 -0.099140206 -0.099140206 -0.099140206 + 17940 1.794 0.70559494 0.70559353 5.481314e-08 -0.099142796 -0.099142796 -0.099142796 + 17950 1.795 0.70559952 0.7055981 3.9460048e-08 -0.099145378 -0.099145378 -0.099145378 + 17960 1.796 0.70560409 0.70560266 2.2957502e-08 -0.099147952 -0.099147952 -0.099147952 + 17970 1.797 0.70560864 0.7056072 5.6869442e-09 -0.099150518 -0.099150518 -0.099150518 + 17980 1.798 0.70561317 0.70561173 -1.1953717e-08 -0.099153077 -0.099153077 -0.099153077 + 17990 1.799 0.70561769 0.70561625 -2.9559276e-08 -0.099155628 -0.099155628 -0.099155628 + 18000 1.8 0.70562219 0.70562076 -4.6726531e-08 -0.099158171 -0.099158171 -0.099158171 + 18010 1.801 0.70562668 0.70562526 -6.3063516e-08 -0.099160707 -0.099160707 -0.099160707 + 18020 1.802 0.70563115 0.70562974 -7.819845e-08 -0.099163235 -0.099163235 -0.099163235 + 18030 1.803 0.70563561 0.70563422 -9.1788187e-08 -0.099165756 -0.099165756 -0.099165756 + 18040 1.804 0.70564005 0.70563868 -1.03526e-07 -0.099168268 -0.099168268 -0.099168268 + 18050 1.805 0.70564448 0.70564312 -1.131485e-07 -0.099170774 -0.099170774 -0.099170774 + 18060 1.806 0.70564889 0.70564756 -1.2044154e-07 -0.099173272 -0.099173272 -0.099173272 + 18070 1.807 0.70565329 0.70565198 -1.2524497e-07 -0.099175762 -0.099175762 -0.099175762 + 18080 1.808 0.70565768 0.70565639 -1.2745617e-07 -0.099178245 -0.099178245 -0.099178245 + 18090 1.809 0.70566205 0.70566079 -1.2703218e-07 -0.09918072 -0.09918072 -0.09918072 + 18100 1.81 0.70566641 0.70566518 -1.2399058e-07 -0.099183188 -0.099183188 -0.099183188 + 18110 1.811 0.70567076 0.70566955 -1.1840886e-07 -0.099185648 -0.099185648 -0.099185648 + 18120 1.812 0.70567509 0.7056739 -1.1042245e-07 -0.099188101 -0.099188101 -0.099188101 + 18130 1.813 0.70567941 0.70567824 -1.0022152e-07 -0.099190547 -0.099190547 -0.099190547 + 18140 1.814 0.70568372 0.70568257 -8.8046375e-08 -0.099192985 -0.099192985 -0.099192985 + 18150 1.815 0.70568802 0.70568688 -7.4181867e-08 -0.099195416 -0.099195416 -0.099195416 + 18160 1.816 0.70569231 0.70569118 -5.8950699e-08 -0.09919784 -0.09919784 -0.09919784 + 18170 1.817 0.70569659 0.70569547 -4.2705933e-08 -0.099200256 -0.099200256 -0.099200256 + 18180 1.818 0.70570085 0.70569974 -2.5822808e-08 -0.099202665 -0.099202665 -0.099202665 + 18190 1.819 0.7057051 0.70570399 -8.690076e-09 -0.099205067 -0.099205067 -0.099205067 + 18200 1.82 0.70570935 0.70570823 8.2989437e-09 -0.099207462 -0.099207462 -0.099207462 + 18210 1.821 0.70571358 0.70571246 2.4755394e-08 -0.099209849 -0.099209849 -0.099209849 + 18220 1.822 0.7057178 0.70571667 4.0303774e-08 -0.099212229 -0.099212229 -0.099212229 + 18230 1.823 0.70572201 0.70572087 5.4590506e-08 -0.099214602 -0.099214602 -0.099214602 + 18240 1.824 0.70572621 0.70572505 6.7291973e-08 -0.099216968 -0.099216968 -0.099216968 + 18250 1.825 0.7057304 0.70572922 7.8121845e-08 -0.099219327 -0.099219327 -0.099219327 + 18260 1.826 0.70573457 0.70573337 8.683753e-08 -0.099221679 -0.099221679 -0.099221679 + 18270 1.827 0.70573874 0.70573751 9.3245603e-08 -0.099224023 -0.099224023 -0.099224023 + 18280 1.828 0.70574289 0.70574164 9.7206098e-08 -0.099226361 -0.099226361 -0.099226361 + 18290 1.829 0.70574703 0.70574576 9.8635549e-08 -0.099228691 -0.099228691 -0.099228691 + 18300 1.83 0.70575116 0.70574986 9.7508745e-08 -0.099231015 -0.099231015 -0.099231015 + 18310 1.831 0.70575527 0.70575395 9.3859127e-08 -0.099233331 -0.099233331 -0.099233331 + 18320 1.832 0.70575937 0.70575803 8.7777853e-08 -0.099235641 -0.099235641 -0.099235641 + 18330 1.833 0.70576346 0.7057621 7.941154e-08 -0.099237943 -0.099237943 -0.099237943 + 18340 1.834 0.70576754 0.70576616 6.8958732e-08 -0.099240239 -0.099240239 -0.099240239 + 18350 1.835 0.7057716 0.7057702 5.6665204e-08 -0.099242528 -0.099242528 -0.099242528 + 18360 1.836 0.70577565 0.70577424 4.2818186e-08 -0.099244809 -0.099244809 -0.099244809 + 18370 1.837 0.70577968 0.70577826 2.7739657e-08 -0.099247084 -0.099247084 -0.099247084 + 18380 1.838 0.7057837 0.70578228 1.1778865e-08 -0.099249353 -0.099249353 -0.099249353 + 18390 1.839 0.70578771 0.70578628 -4.6957605e-09 -0.099251614 -0.099251614 -0.099251614 + 18400 1.84 0.7057917 0.70579027 -2.1305108e-08 -0.099253868 -0.099253868 -0.099253868 + 18410 1.841 0.70579568 0.70579425 -3.7668103e-08 -0.099256116 -0.099256116 -0.099256116 + 18420 1.842 0.70579964 0.70579823 -5.3410454e-08 -0.099258357 -0.099258357 -0.099258357 + 18430 1.843 0.7058036 0.70580219 -6.8173204e-08 -0.099260591 -0.099260591 -0.099260591 + 18440 1.844 0.70580753 0.70580614 -8.1620914e-08 -0.099262818 -0.099262818 -0.099262818 + 18450 1.845 0.70581146 0.70581008 -9.3449288e-08 -0.099265039 -0.099265039 -0.099265039 + 18460 1.846 0.70581537 0.70581401 -1.0339205e-07 -0.099267253 -0.099267253 -0.099267253 + 18470 1.847 0.70581927 0.70581793 -1.1122692e-07 -0.099269461 -0.099269461 -0.099269461 + 18480 1.848 0.70582316 0.70582184 -1.1678063e-07 -0.099271661 -0.099271661 -0.099271661 + 18490 1.849 0.70582703 0.70582574 -1.1993267e-07 -0.099273855 -0.099273855 -0.099273855 + 18500 1.85 0.70583089 0.70582962 -1.2061797e-07 -0.099276043 -0.099276043 -0.099276043 + 18510 1.851 0.70583474 0.7058335 -1.1882819e-07 -0.099278224 -0.099278224 -0.099278224 + 18520 1.852 0.70583858 0.70583736 -1.1461174e-07 -0.099280398 -0.099280398 -0.099280398 + 18530 1.853 0.70584241 0.70584121 -1.0807252e-07 -0.099282566 -0.099282566 -0.099282566 + 18540 1.854 0.70584623 0.70584505 -9.9367345e-08 -0.099284727 -0.099284727 -0.099284727 + 18550 1.855 0.70585004 0.70584887 -8.8702244e-08 -0.099286882 -0.099286882 -0.099286882 + 18560 1.856 0.70585383 0.70585268 -7.6327541e-08 -0.09928903 -0.09928903 -0.09928903 + 18570 1.857 0.70585762 0.70585648 -6.2532008e-08 -0.099291172 -0.099291172 -0.099291172 + 18580 1.858 0.7058614 0.70586027 -4.7636131e-08 -0.099293307 -0.099293307 -0.099293307 + 18590 1.859 0.70586517 0.70586404 -3.1984665e-08 -0.099295436 -0.099295436 -0.099295436 + 18600 1.86 0.70586892 0.7058678 -1.593866e-08 -0.099297558 -0.099297558 -0.099297558 + 18610 1.861 0.70587267 0.70587155 1.3286207e-10 -0.099299674 -0.099299674 -0.099299674 + 18620 1.862 0.70587641 0.70587528 1.5861394e-08 -0.099301784 -0.099301784 -0.099301784 + 18630 1.863 0.70588014 0.705879 3.0887388e-08 -0.099303888 -0.099303888 -0.099303888 + 18640 1.864 0.70588386 0.70588271 4.4868472e-08 -0.099305985 -0.099305985 -0.099305985 + 18650 1.865 0.70588757 0.7058864 5.7487246e-08 -0.099308075 -0.099308075 -0.099308075 + 18660 1.866 0.70589127 0.70589009 6.8458489e-08 -0.09931016 -0.09931016 -0.09931016 + 18670 1.867 0.70589495 0.70589376 7.7535597e-08 -0.099312238 -0.099312238 -0.099312238 + 18680 1.868 0.70589863 0.70589742 8.4516128e-08 -0.09931431 -0.09931431 -0.09931431 + 18690 1.869 0.7059023 0.70590106 8.9246306e-08 -0.099316375 -0.099316375 -0.099316375 + 18700 1.87 0.70590596 0.7059047 9.1624407e-08 -0.099318435 -0.099318435 -0.099318435 + 18710 1.871 0.70590961 0.70590832 9.1602936e-08 -0.099320488 -0.099320488 -0.099320488 + 18720 1.872 0.70591324 0.70591194 8.9189552e-08 -0.099322535 -0.099322535 -0.099322535 + 18730 1.873 0.70591687 0.70591554 8.4446732e-08 -0.099324576 -0.099324576 -0.099324576 + 18740 1.874 0.70592048 0.70591913 7.7490175e-08 -0.09932661 -0.09932661 -0.09932661 + 18750 1.875 0.70592408 0.70592272 6.848599e-08 -0.099328639 -0.099328639 -0.099328639 + 18760 1.876 0.70592767 0.70592629 5.764674e-08 -0.099330661 -0.099330661 -0.099330661 + 18770 1.877 0.70593125 0.70592985 4.522643e-08 -0.099332677 -0.099332677 -0.099332677 + 18780 1.878 0.70593481 0.70593341 3.1514557e-08 -0.099334688 -0.099334688 -0.099334688 + 18790 1.879 0.70593837 0.70593695 1.6829372e-08 -0.099336692 -0.099336692 -0.099336692 + 18800 1.88 0.70594191 0.70594049 1.5104927e-09 -0.09933869 -0.09933869 -0.09933869 + 18810 1.881 0.70594544 0.70594402 -1.4088944e-08 -0.099340682 -0.099340682 -0.099340682 + 18820 1.882 0.70594895 0.70594753 -2.9610419e-08 -0.099342668 -0.099342668 -0.099342668 + 18830 1.883 0.70595245 0.70595104 -4.4698272e-08 -0.099344648 -0.099344648 -0.099344648 + 18840 1.884 0.70595595 0.70595454 -5.9007842e-08 -0.099346623 -0.099346623 -0.099346623 + 18850 1.885 0.70595943 0.70595803 -7.2213343e-08 -0.099348591 -0.099348591 -0.099348591 + 18860 1.886 0.70596289 0.70596152 -8.4015276e-08 -0.099350553 -0.099350553 -0.099350553 + 18870 1.887 0.70596635 0.70596499 -9.4147216e-08 -0.09935251 -0.09935251 -0.09935251 + 18880 1.888 0.70596979 0.70596845 -1.0238183e-07 -0.09935446 -0.09935446 -0.09935446 + 18890 1.889 0.70597323 0.7059719 -1.0853597e-07 -0.099356405 -0.099356405 -0.099356405 + 18900 1.89 0.70597665 0.70597535 -1.1247473e-07 -0.099358343 -0.099358343 -0.099358343 + 18910 1.891 0.70598006 0.70597878 -1.1411442e-07 -0.099360276 -0.099360276 -0.099360276 + 18920 1.892 0.70598346 0.7059822 -1.1342432e-07 -0.099362203 -0.099362203 -0.099362203 + 18930 1.893 0.70598685 0.70598562 -1.1042722e-07 -0.099364125 -0.099364125 -0.099364125 + 18940 1.894 0.70599023 0.70598902 -1.0519876e-07 -0.09936604 -0.09936604 -0.09936604 + 18950 1.895 0.70599361 0.70599241 -9.7865496e-08 -0.09936795 -0.09936795 -0.09936795 + 18960 1.896 0.70599697 0.70599579 -8.8601904e-08 -0.099369854 -0.099369854 -0.099369854 + 18970 1.897 0.70600032 0.70599916 -7.7626193e-08 -0.099371752 -0.099371752 -0.099371752 + 18980 1.898 0.70600367 0.70600251 -6.5195188e-08 -0.099373644 -0.099373644 -0.099373644 + 18990 1.899 0.706007 0.70600586 -5.1598322e-08 -0.099375531 -0.099375531 -0.099375531 + 19000 1.9 0.70601033 0.70600919 -3.71509e-08 -0.099377412 -0.099377412 -0.099377412 + 19010 1.901 0.70601365 0.70601252 -2.2186797e-08 -0.099379288 -0.099379288 -0.099379288 + 19020 1.902 0.70601696 0.70601583 -7.0507367e-09 -0.099381157 -0.099381157 -0.099381157 + 19030 1.903 0.70602026 0.70601913 7.9096381e-09 -0.099383021 -0.099383021 -0.099383021 + 19040 1.904 0.70602355 0.70602241 2.2351752e-08 -0.09938488 -0.09938488 -0.09938488 + 19050 1.905 0.70602684 0.70602569 3.5945938e-08 -0.099386733 -0.099386733 -0.099386733 + 19060 1.906 0.70603012 0.70602895 4.8382957e-08 -0.09938858 -0.09938858 -0.09938858 + 19070 1.907 0.70603338 0.70603221 5.9381035e-08 -0.099390422 -0.099390422 -0.099390422 + 19080 1.908 0.70603664 0.70603545 6.8692236e-08 -0.099392258 -0.099392258 -0.099392258 + 19090 1.909 0.70603989 0.70603868 7.6108057e-08 -0.099394089 -0.099394089 -0.099394089 + 19100 1.91 0.70604313 0.7060419 8.1464086e-08 -0.099395914 -0.099395914 -0.099395914 + 19110 1.911 0.70604637 0.70604511 8.4643642e-08 -0.099397733 -0.099397733 -0.099397733 + 19120 1.912 0.70604959 0.70604832 8.5580314e-08 -0.099399547 -0.099399547 -0.099399547 + 19130 1.913 0.7060528 0.70605151 8.4259331e-08 -0.099401356 -0.099401356 -0.099401356 + 19140 1.914 0.706056 0.70605469 8.0717747e-08 -0.099403159 -0.099403159 -0.099403159 + 19150 1.915 0.7060592 0.70605786 7.5043437e-08 -0.099404957 -0.099404957 -0.099404957 + 19160 1.916 0.70606238 0.70606103 6.7372934e-08 -0.099406749 -0.099406749 -0.099406749 + 19170 1.917 0.70606555 0.70606418 5.7888148e-08 -0.099408536 -0.099408536 -0.099408536 + 19180 1.918 0.70606871 0.70606733 4.6812058e-08 -0.099410318 -0.099410318 -0.099410318 + 19190 1.919 0.70607186 0.70607047 3.4403481e-08 -0.099412094 -0.099412094 -0.099412094 + 19200 1.92 0.706075 0.7060736 2.0951022e-08 -0.099413865 -0.099413865 -0.099413865 + 19210 1.921 0.70607813 0.70607672 6.7663709e-09 -0.09941563 -0.09941563 -0.09941563 + 19220 1.922 0.70608125 0.70607984 -7.8229194e-09 -0.099417391 -0.099417391 -0.099417391 + 19230 1.923 0.70608435 0.70608294 -2.2480992e-08 -0.099419145 -0.099419145 -0.099419145 + 19240 1.924 0.70608745 0.70608604 -3.6871415e-08 -0.099420895 -0.099420895 -0.099420895 + 19250 1.925 0.70609053 0.70608913 -5.0664901e-08 -0.099422639 -0.099422639 -0.099422639 + 19260 1.926 0.70609361 0.70609222 -6.3546837e-08 -0.099424378 -0.099424378 -0.099424378 + 19270 1.927 0.70609667 0.70609529 -7.5224461e-08 -0.099426112 -0.099426112 -0.099426112 + 19280 1.928 0.70609972 0.70609836 -8.543351e-08 -0.09942784 -0.09942784 -0.09942784 + 19290 1.929 0.70610277 0.70610142 -9.3944199e-08 -0.099429564 -0.099429564 -0.099429564 + 19300 1.93 0.7061058 0.70610447 -1.0056639e-07 -0.099431282 -0.099431282 -0.099431282 + 19310 1.931 0.70610882 0.70610751 -1.0515382e-07 -0.099432995 -0.099432995 -0.099432995 + 19320 1.932 0.70611183 0.70611055 -1.0760737e-07 -0.099434703 -0.099434703 -0.099434703 + 19330 1.933 0.70611484 0.70611357 -1.0787713e-07 -0.099436405 -0.099436405 -0.099436405 + 19340 1.934 0.70611783 0.70611659 -1.0596347e-07 -0.099438103 -0.099438103 -0.099438103 + 19350 1.935 0.70612082 0.70611959 -1.0191683e-07 -0.099439795 -0.099439795 -0.099439795 + 19360 1.936 0.7061238 0.70612259 -9.5836422e-08 -0.099441482 -0.099441482 -0.099441482 + 19370 1.937 0.70612677 0.70612557 -8.7867838e-08 -0.099443164 -0.099443164 -0.099443164 + 19380 1.938 0.70612973 0.70612855 -7.8199538e-08 -0.099444842 -0.099444842 -0.099444842 + 19390 1.939 0.70613268 0.70613152 -6.7058418e-08 -0.099446514 -0.099446514 -0.099446514 + 19400 1.94 0.70613563 0.70613447 -5.470448e-08 -0.099448181 -0.099448181 -0.099448181 + 19410 1.941 0.70613857 0.70613742 -4.1424778e-08 -0.099449843 -0.099449843 -0.099449843 + 19420 1.942 0.7061415 0.70614035 -2.7526741e-08 -0.099451499 -0.099451499 -0.099451499 + 19430 1.943 0.70614442 0.70614328 -1.333107e-08 -0.099453151 -0.099453151 -0.099453151 + 19440 1.944 0.70614734 0.70614619 8.3566774e-10 -0.099454798 -0.099454798 -0.099454798 + 19450 1.945 0.70615024 0.7061491 1.4648542e-08 -0.09945644 -0.09945644 -0.09945644 + 19460 1.946 0.70615315 0.70615199 2.7791714e-08 -0.099458077 -0.099458077 -0.099458077 + 19470 1.947 0.70615604 0.70615488 3.9965652e-08 -0.099459709 -0.099459709 -0.099459709 + 19480 1.948 0.70615893 0.70615775 5.0893959e-08 -0.099461337 -0.099461337 -0.099461337 + 19490 1.949 0.70616181 0.70616061 6.032964e-08 -0.099462959 -0.099462959 -0.099462959 + 19500 1.95 0.70616468 0.70616347 6.8060684e-08 -0.099464576 -0.099464576 -0.099464576 + 19510 1.951 0.70616754 0.70616631 7.3914827e-08 -0.099466189 -0.099466189 -0.099466189 + 19520 1.952 0.7061704 0.70616915 7.7763378e-08 -0.099467796 -0.099467796 -0.099467796 + 19530 1.953 0.70617324 0.70617198 7.952405e-08 -0.099469399 -0.099469399 -0.099469399 + 19540 1.954 0.70617608 0.7061748 7.9162704e-08 -0.099470997 -0.099470997 -0.099470997 + 19550 1.955 0.70617891 0.70617761 7.6693992e-08 -0.09947259 -0.09947259 -0.09947259 + 19560 1.956 0.70618173 0.70618041 7.2180872e-08 -0.099474178 -0.099474178 -0.099474178 + 19570 1.957 0.70618454 0.7061832 6.5733024e-08 -0.099475762 -0.099475762 -0.099475762 + 19580 1.958 0.70618735 0.70618599 5.7504189e-08 -0.099477341 -0.099477341 -0.099477341 + 19590 1.959 0.70619014 0.70618877 4.7688515e-08 -0.099478915 -0.099478915 -0.099478915 + 19600 1.96 0.70619292 0.70619154 3.6515978e-08 -0.099480484 -0.099480484 -0.099480484 + 19610 1.961 0.7061957 0.70619431 2.4246999e-08 -0.099482048 -0.099482048 -0.099482048 + 19620 1.962 0.70619846 0.70619706 1.1166379e-08 -0.099483608 -0.099483608 -0.099483608 + 19630 1.963 0.70620122 0.70619981 -2.4233094e-09 -0.099485163 -0.099485163 -0.099485163 + 19640 1.964 0.70620396 0.70620256 -1.6208717e-08 -0.099486713 -0.099486713 -0.099486713 + 19650 1.965 0.70620669 0.7062053 -2.9872943e-08 -0.099488259 -0.099488259 -0.099488259 + 19660 1.966 0.70620942 0.70620803 -4.3102813e-08 -0.0994898 -0.0994898 -0.0994898 + 19670 1.967 0.70621214 0.70621075 -5.5596058e-08 -0.099491336 -0.099491336 -0.099491336 + 19680 1.968 0.70621484 0.70621347 -6.7068215e-08 -0.099492868 -0.099492868 -0.099492868 + 19690 1.969 0.70621754 0.70621617 -7.7259102e-08 -0.099494395 -0.099494395 -0.099494395 + 19700 1.97 0.70622022 0.70621888 -8.5938718e-08 -0.099495918 -0.099495918 -0.099495918 + 19710 1.971 0.7062229 0.70622157 -9.2912428e-08 -0.099497436 -0.099497436 -0.099497436 + 19720 1.972 0.70622557 0.70622426 -9.8025326e-08 -0.099498949 -0.099498949 -0.099498949 + 19730 1.973 0.70622823 0.70622694 -1.0116567e-07 -0.099500458 -0.099500458 -0.099500458 + 19740 1.974 0.70623089 0.70622961 -1.0226731e-07 -0.099501962 -0.099501962 -0.099501962 + 19750 1.975 0.70623353 0.70623228 -1.0131109e-07 -0.099503461 -0.099503461 -0.099503461 + 19760 1.976 0.70623617 0.70623493 -9.8325127e-08 -0.099504956 -0.099504956 -0.099504956 + 19770 1.977 0.7062388 0.70623758 -9.3384031e-08 -0.099506447 -0.099506447 -0.099506447 + 19780 1.978 0.70624142 0.70624022 -8.660706e-08 -0.099507933 -0.099507933 -0.099507933 + 19790 1.979 0.70624404 0.70624285 -7.8155241e-08 -0.099509415 -0.099509415 -0.099509415 + 19800 1.98 0.70624664 0.70624547 -6.8227557e-08 -0.099510892 -0.099510892 -0.099510892 + 19810 1.981 0.70624924 0.70624808 -5.7056261e-08 -0.099512365 -0.099512365 -0.099512365 + 19820 1.982 0.70625184 0.70625068 -4.4901454e-08 -0.099513833 -0.099513833 -0.099513833 + 19830 1.983 0.70625443 0.70625328 -3.2045025e-08 -0.099515297 -0.099515297 -0.099515297 + 19840 1.984 0.70625701 0.70625586 -1.8784125e-08 -0.099516756 -0.099516756 -0.099516756 + 19850 1.985 0.70625958 0.70625844 -5.4242937e-09 -0.099518211 -0.099518211 -0.099518211 + 19860 1.986 0.70626215 0.706261 7.7275713e-09 -0.099519662 -0.099519662 -0.099519662 + 19870 1.987 0.70626472 0.70626356 2.0370265e-08 -0.099521108 -0.099521108 -0.099521108 + 19880 1.988 0.70626727 0.70626611 3.2215168e-08 -0.09952255 -0.09952255 -0.09952255 + 19890 1.989 0.70626982 0.70626864 4.2992837e-08 -0.099523987 -0.099523987 -0.099523987 + 19900 1.99 0.70627237 0.70627117 5.2459126e-08 -0.09952542 -0.09952542 -0.09952542 + 19910 1.991 0.7062749 0.7062737 6.0400718e-08 -0.099526849 -0.099526849 -0.099526849 + 19920 1.992 0.70627743 0.70627621 6.6639927e-08 -0.099528273 -0.099528273 -0.099528273 + 19930 1.993 0.70627995 0.70627871 7.1038669e-08 -0.099529694 -0.099529694 -0.099529694 + 19940 1.994 0.70628247 0.70628121 7.3501515e-08 -0.09953111 -0.09953111 -0.09953111 + 19950 1.995 0.70628498 0.7062837 7.3977751e-08 -0.099532521 -0.099532521 -0.099532521 + 19960 1.996 0.70628748 0.70628618 7.246241e-08 -0.099533929 -0.099533929 -0.099533929 + 19970 1.997 0.70628997 0.70628865 6.8996248e-08 -0.099535332 -0.099535332 -0.099535332 + 19980 1.998 0.70629245 0.70629112 6.3664676e-08 -0.099536731 -0.099536731 -0.099536731 + 19990 1.999 0.70629493 0.70629358 5.6595659e-08 -0.099538125 -0.099538125 -0.099538125 + 20000 2 0.7062974 0.70629604 4.7956659e-08 -0.099539516 -0.099539516 -0.099539516 + 20010 2.001 0.70629986 0.70629848 3.7950669e-08 -0.099540902 -0.099540902 -0.099540902 + 20020 2.002 0.70630231 0.70630093 2.681145e-08 -0.099542284 -0.099542284 -0.099542284 + 20030 2.003 0.70630475 0.70630336 1.479807e-08 -0.099543662 -0.099543662 -0.099543662 + 20040 2.004 0.70630718 0.70630579 2.1888892e-09 -0.099545036 -0.099545036 -0.099545036 + 20050 2.005 0.70630961 0.70630821 -1.0724895e-08 -0.099546405 -0.099546405 -0.099546405 + 20060 2.006 0.70631202 0.70631063 -2.3645964e-08 -0.099547771 -0.099547771 -0.099547771 + 20070 2.007 0.70631443 0.70631304 -3.6277725e-08 -0.099549132 -0.099549132 -0.099549132 + 20080 2.008 0.70631683 0.70631545 -4.8331111e-08 -0.099550489 -0.099550489 -0.099550489 + 20090 2.009 0.70631922 0.70631785 -5.95312e-08 -0.099551842 -0.099551842 -0.099551842 + 20100 2.01 0.7063216 0.70632024 -6.9623478e-08 -0.099553191 -0.099553191 -0.099553191 + 20110 2.011 0.70632397 0.70632263 -7.8379623e-08 -0.099554536 -0.099554536 -0.099554536 + 20120 2.012 0.70632634 0.70632501 -8.5602665e-08 -0.099555877 -0.099555877 -0.099555877 + 20130 2.013 0.7063287 0.70632738 -9.1131414e-08 -0.099557214 -0.099557214 -0.099557214 + 20140 2.014 0.70633105 0.70632975 -9.4844056e-08 -0.099558547 -0.099558547 -0.099558547 + 20150 2.015 0.70633339 0.70633211 -9.6660828e-08 -0.099559875 -0.099559875 -0.099559875 + 20160 2.016 0.70633573 0.70633446 -9.6545724e-08 -0.0995612 -0.0995612 -0.0995612 + 20170 2.017 0.70633805 0.70633681 -9.4507189e-08 -0.099562521 -0.099562521 -0.099562521 + 20180 2.018 0.70634038 0.70633915 -9.0597798e-08 -0.099563838 -0.099563838 -0.099563838 + 20190 2.019 0.70634269 0.70634148 -8.4912909e-08 -0.09956515 -0.09956515 -0.09956515 + 20200 2.02 0.706345 0.7063438 -7.7588353e-08 -0.099566459 -0.099566459 -0.099566459 + 20210 2.021 0.7063473 0.70634612 -6.8797191e-08 -0.099567764 -0.099567764 -0.099567764 + 20220 2.022 0.7063496 0.70634842 -5.8745631e-08 -0.099569065 -0.099569065 -0.099569065 + 20230 2.023 0.70635189 0.70635072 -4.7668196e-08 -0.099570362 -0.099570362 -0.099570362 + 20240 2.024 0.70635418 0.70635302 -3.5822255e-08 -0.099571655 -0.099571655 -0.099571655 + 20250 2.025 0.70635646 0.7063553 -2.3482047e-08 -0.099572944 -0.099572944 -0.099572944 + 20260 2.026 0.70635873 0.70635757 -1.0932334e-08 -0.09957423 -0.09957423 -0.09957423 + 20270 2.027 0.706361 0.70635984 1.5381658e-09 -0.099575511 -0.099575511 -0.099575511 + 20280 2.028 0.70636326 0.7063621 1.3643418e-08 -0.099576788 -0.099576788 -0.099576788 + 20290 2.029 0.70636552 0.70636435 2.5106632e-08 -0.099578062 -0.099578062 -0.099578062 + 20300 2.03 0.70636777 0.70636659 3.5666585e-08 -0.099579332 -0.099579332 -0.099579332 + 20310 2.031 0.70637002 0.70636883 4.5083572e-08 -0.099580598 -0.099580598 -0.099580598 + 20320 2.032 0.70637226 0.70637105 5.3144849e-08 -0.09958186 -0.09958186 -0.09958186 + 20330 2.033 0.70637449 0.70637327 5.9669428e-08 -0.099583118 -0.099583118 -0.099583118 + 20340 2.034 0.70637672 0.70637548 6.4512146e-08 -0.099584373 -0.099584373 -0.099584373 + 20350 2.035 0.70637894 0.70637769 6.7566882e-08 -0.099585624 -0.099585624 -0.099585624 + 20360 2.036 0.70638116 0.70637989 6.8768883e-08 -0.099586871 -0.099586871 -0.099586871 + 20370 2.037 0.70638337 0.70638208 6.8096123e-08 -0.099588114 -0.099588114 -0.099588114 + 20380 2.038 0.70638557 0.70638426 6.5569679e-08 -0.099589353 -0.099589353 -0.099589353 + 20390 2.039 0.70638776 0.70638644 6.1253126e-08 -0.099590589 -0.099590589 -0.099590589 + 20400 2.04 0.70638995 0.70638861 5.5250939e-08 -0.099591821 -0.099591821 -0.099591821 + 20410 2.041 0.70639213 0.70639078 4.7705984e-08 -0.099593049 -0.099593049 -0.099593049 + 20420 2.042 0.7063943 0.70639294 3.8796111e-08 -0.099594274 -0.099594274 -0.099594274 + 20430 2.043 0.70639647 0.7063951 2.8729978e-08 -0.099595495 -0.099595495 -0.099595495 + 20440 2.044 0.70639863 0.70639725 1.7742159e-08 -0.099596712 -0.099596712 -0.099596712 + 20450 2.045 0.70640078 0.70639939 6.0876855e-09 -0.099597925 -0.099597925 -0.099597925 + 20460 2.046 0.70640292 0.70640153 -5.9638709e-09 -0.099599135 -0.099599135 -0.099599135 + 20470 2.047 0.70640505 0.70640367 -1.8134631e-08 -0.099600341 -0.099600341 -0.099600341 + 20480 2.048 0.70640718 0.7064058 -3.0144812e-08 -0.099601544 -0.099601544 -0.099601544 + 20490 2.049 0.7064093 0.70640792 -4.1719159e-08 -0.099602742 -0.099602742 -0.099602742 + 20500 2.05 0.70641141 0.70641004 -5.2593248e-08 -0.099603938 -0.099603938 -0.099603938 + 20510 2.051 0.70641351 0.70641215 -6.2519525e-08 -0.099605129 -0.099605129 -0.099605129 + 20520 2.052 0.70641561 0.70641426 -7.1272944e-08 -0.099606317 -0.099606317 -0.099606317 + 20530 2.053 0.7064177 0.70641636 -7.8656058e-08 -0.099607502 -0.099607502 -0.099607502 + 20540 2.054 0.70641978 0.70641846 -8.4503476e-08 -0.099608683 -0.099608683 -0.099608683 + 20550 2.055 0.70642186 0.70642055 -8.8685564e-08 -0.09960986 -0.09960986 -0.09960986 + 20560 2.056 0.70642393 0.70642264 -9.1111311e-08 -0.099611034 -0.099611034 -0.099611034 + 20570 2.057 0.70642599 0.70642472 -9.1730305e-08 -0.099612204 -0.099612204 -0.099612204 + 20580 2.058 0.70642804 0.70642679 -9.0533768e-08 -0.09961337 -0.09961337 -0.09961337 + 20590 2.059 0.70643009 0.70642885 -8.7554636e-08 -0.099614534 -0.099614534 -0.099614534 + 20600 2.06 0.70643214 0.70643091 -8.2866671e-08 -0.099615693 -0.099615693 -0.099615693 + 20610 2.061 0.70643418 0.70643297 -7.6582653e-08 -0.099616849 -0.099616849 -0.099616849 + 20620 2.062 0.70643621 0.70643501 -6.8851668e-08 -0.099618002 -0.099618002 -0.099618002 + 20630 2.063 0.70643824 0.70643705 -5.9855578e-08 -0.099619151 -0.099619151 -0.099619151 + 20640 2.064 0.70644026 0.70643908 -4.9804747e-08 -0.099620297 -0.099620297 -0.099620297 + 20650 2.065 0.70644228 0.70644111 -3.8933125e-08 -0.099621439 -0.099621439 -0.099621439 + 20660 2.066 0.70644429 0.70644312 -2.7492808e-08 -0.099622578 -0.099622578 -0.099622578 + 20670 2.067 0.7064463 0.70644513 -1.5748189e-08 -0.099623713 -0.099623713 -0.099623713 + 20680 2.068 0.7064483 0.70644714 -3.969858e-09 -0.099624845 -0.099624845 -0.099624845 + 20690 2.069 0.7064503 0.70644913 7.5716351e-09 -0.099625973 -0.099625973 -0.099625973 + 20700 2.07 0.70645229 0.70645112 1.8611991e-08 -0.099627098 -0.099627098 -0.099627098 + 20710 2.071 0.70645428 0.7064531 2.889921e-08 -0.09962822 -0.09962822 -0.09962822 + 20720 2.072 0.70645627 0.70645507 3.8199345e-08 -0.099629338 -0.099629338 -0.099629338 + 20730 2.073 0.70645824 0.70645704 4.6301814e-08 -0.099630453 -0.099630453 -0.099630453 + 20740 2.074 0.70646022 0.706459 5.3024171e-08 -0.099631564 -0.099631564 -0.099631564 + 20750 2.075 0.70646219 0.70646095 5.8216207e-08 -0.099632672 -0.099632672 -0.099632672 + 20760 2.076 0.70646415 0.7064629 6.1763304e-08 -0.099633777 -0.099633777 -0.099633777 + 20770 2.077 0.70646611 0.70646484 6.3588961e-08 -0.099634879 -0.099634879 -0.099634879 + 20780 2.078 0.70646806 0.70646678 6.3656436e-08 -0.099635977 -0.099635977 -0.099635977 + 20790 2.079 0.70647 0.70646871 6.1969469e-08 -0.099637072 -0.099637072 -0.099637072 + 20800 2.08 0.70647194 0.70647063 5.8572077e-08 -0.099638163 -0.099638163 -0.099638163 + 20810 2.081 0.70647387 0.70647255 5.354742e-08 -0.099639251 -0.099639251 -0.099639251 + 20820 2.082 0.7064758 0.70647446 4.7015777e-08 -0.099640336 -0.099640336 -0.099640336 + 20830 2.083 0.70647772 0.70647637 3.9131669e-08 -0.099641418 -0.099641418 -0.099641418 + 20840 2.084 0.70647963 0.70647827 3.0080213e-08 -0.099642496 -0.099642496 -0.099642496 + 20850 2.085 0.70648154 0.70648017 2.0072773e-08 -0.099643571 -0.099643571 -0.099643571 + 20860 2.086 0.70648344 0.70648206 9.3420337e-09 -0.099644643 -0.099644643 -0.099644643 + 20870 2.087 0.70648533 0.70648395 -1.8634114e-09 -0.099645712 -0.099645712 -0.099645712 + 20880 2.088 0.70648722 0.70648584 -1.3284814e-08 -0.099646777 -0.099646777 -0.099646777 + 20890 2.089 0.7064891 0.70648772 -2.4659244e-08 -0.099647839 -0.099647839 -0.099647839 + 20900 2.09 0.70649097 0.70648959 -3.5725639e-08 -0.099648898 -0.099648898 -0.099648898 + 20910 2.091 0.70649283 0.70649146 -4.6230798e-08 -0.099649954 -0.099649954 -0.099649954 + 20920 2.092 0.70649469 0.70649333 -5.5935165e-08 -0.099651006 -0.099651006 -0.099651006 + 20930 2.093 0.70649654 0.70649519 -6.4618297e-08 -0.099652056 -0.099652056 -0.099652056 + 20940 2.094 0.70649839 0.70649705 -7.2083863e-08 -0.099653102 -0.099653102 -0.099653102 + 20950 2.095 0.70650023 0.7064989 -7.8164087e-08 -0.099654145 -0.099654145 -0.099654145 + 20960 2.096 0.70650206 0.70650075 -8.2723507e-08 -0.099655185 -0.099655185 -0.099655185 + 20970 2.097 0.70650388 0.70650259 -8.5661997e-08 -0.099656221 -0.099656221 -0.099656221 + 20980 2.098 0.7065057 0.70650443 -8.6916954e-08 -0.099657255 -0.099657255 -0.099657255 + 20990 2.099 0.70650752 0.70650626 -8.6464627e-08 -0.099658285 -0.099658285 -0.099658285 + 21000 2.1 0.70650933 0.70650808 -8.4320545e-08 -0.099659313 -0.099659313 -0.099659313 + 21010 2.101 0.70651113 0.7065099 -8.0539042e-08 -0.099660337 -0.099660337 -0.099660337 + 21020 2.102 0.70651293 0.70651172 -7.5211894e-08 -0.099661358 -0.099661358 -0.099661358 + 21030 2.103 0.70651473 0.70651352 -6.8466096e-08 -0.099662376 -0.099662376 -0.099662376 + 21040 2.104 0.70651652 0.70651533 -6.0460842e-08 -0.099663391 -0.099663391 -0.099663391 + 21050 2.105 0.70651831 0.70651712 -5.1383775e-08 -0.099664403 -0.099664403 -0.099664403 + 21060 2.106 0.70652009 0.70651891 -4.1446585e-08 -0.099665412 -0.099665412 -0.099665412 + 21070 2.107 0.70652186 0.70652069 -3.0880082e-08 -0.099666418 -0.099666418 -0.099666418 + 21080 2.108 0.70652364 0.70652247 -1.9928835e-08 -0.099667421 -0.099667421 -0.099667421 + 21090 2.109 0.70652541 0.70652423 -8.845512e-09 -0.09966842 -0.09966842 -0.09966842 + 21100 2.11 0.70652717 0.706526 2.1149427e-09 -0.099669417 -0.099669417 -0.099669417 + 21110 2.111 0.70652893 0.70652775 1.2701175e-08 -0.099670411 -0.099670411 -0.099670411 + 21120 2.112 0.70653069 0.7065295 2.267118e-08 -0.099671401 -0.099671401 -0.099671401 + 21130 2.113 0.70653244 0.70653125 3.1797835e-08 -0.099672389 -0.099672389 -0.099672389 + 21140 2.114 0.70653419 0.70653298 3.9874067e-08 -0.099673374 -0.099673374 -0.099673374 + 21150 2.115 0.70653593 0.70653471 4.6717553e-08 -0.099674355 -0.099674355 -0.099674355 + 21160 2.116 0.70653767 0.70653644 5.2174829e-08 -0.099675334 -0.099675334 -0.099675334 + 21170 2.117 0.7065394 0.70653816 5.6124731e-08 -0.09967631 -0.09967631 -0.09967631 + 21180 2.118 0.70654113 0.70653987 5.848108e-08 -0.099677283 -0.099677283 -0.099677283 + 21190 2.119 0.70654285 0.70654158 5.9194556e-08 -0.099678253 -0.099678253 -0.099678253 + 21200 2.12 0.70654457 0.70654328 5.825372e-08 -0.09967922 -0.09967922 -0.09967922 + 21210 2.121 0.70654628 0.70654498 5.5685163e-08 -0.099680184 -0.099680184 -0.099680184 + 21220 2.122 0.70654799 0.70654667 5.1552781e-08 -0.099681145 -0.099681145 -0.099681145 + 21230 2.123 0.70654969 0.70654836 4.5956196e-08 -0.099682103 -0.099682103 -0.099682103 + 21240 2.124 0.70655139 0.70655005 3.9028362e-08 -0.099683058 -0.099683058 -0.099683058 + 21250 2.125 0.70655308 0.70655173 3.0932406e-08 -0.099684011 -0.099684011 -0.099684011 + 21260 2.126 0.70655476 0.7065534 2.1857798e-08 -0.09968496 -0.09968496 -0.09968496 + 21270 2.127 0.70655644 0.70655507 1.2015912e-08 -0.099685907 -0.099685907 -0.099685907 + 21280 2.128 0.70655811 0.70655674 1.6351138e-09 -0.099686851 -0.099686851 -0.099686851 + 21290 2.129 0.70655978 0.70655841 -9.0445433e-09 -0.099687792 -0.099687792 -0.099687792 + 21300 2.13 0.70656144 0.70656007 -1.9776862e-08 -0.09968873 -0.09968873 -0.09968873 + 21310 2.131 0.70656309 0.70656172 -3.0315175e-08 -0.099689665 -0.099689665 -0.099689665 + 21320 2.132 0.70656474 0.70656337 -4.0418016e-08 -0.099690598 -0.099690598 -0.099690598 + 21330 2.133 0.70656638 0.70656502 -4.9854645e-08 -0.099691527 -0.099691527 -0.099691527 + 21340 2.134 0.70656802 0.70656667 -5.841032e-08 -0.099692454 -0.099692454 -0.099692454 + 21350 2.135 0.70656965 0.70656831 -6.5891177e-08 -0.099693378 -0.099693378 -0.099693378 + 21360 2.136 0.70657127 0.70656994 -7.2128628e-08 -0.099694299 -0.099694299 -0.099694299 + 21370 2.137 0.70657289 0.70657157 -7.6983148e-08 -0.099695218 -0.099695218 -0.099695218 + 21380 2.138 0.7065745 0.7065732 -8.03474e-08 -0.099696133 -0.099696133 -0.099696133 + 21390 2.139 0.70657611 0.70657482 -8.2148598e-08 -0.099697046 -0.099697046 -0.099697046 + 21400 2.14 0.70657771 0.70657644 -8.2350082e-08 -0.099697956 -0.099697956 -0.099697956 + 21410 2.141 0.70657931 0.70657805 -8.0952044e-08 -0.099698864 -0.099698864 -0.099698864 + 21420 2.142 0.7065809 0.70657966 -7.7991418e-08 -0.099699768 -0.099699768 -0.099699768 + 21430 2.143 0.70658249 0.70658126 -7.3540919e-08 -0.09970067 -0.09970067 -0.09970067 + 21440 2.144 0.70658407 0.70658286 -6.7707267e-08 -0.099701569 -0.099701569 -0.099701569 + 21450 2.145 0.70658566 0.70658445 -6.062863e-08 -0.099702466 -0.099702466 -0.099702466 + 21460 2.146 0.70658723 0.70658604 -5.247136e-08 -0.09970336 -0.09970336 -0.09970336 + 21470 2.147 0.7065888 0.70658762 -4.3426085e-08 -0.099704251 -0.099704251 -0.099704251 + 21480 2.148 0.70659037 0.70658919 -3.3703257e-08 -0.099705139 -0.099705139 -0.099705139 + 21490 2.149 0.70659194 0.70659076 -2.3528257e-08 -0.099706025 -0.099706025 -0.099706025 + 21500 2.15 0.7065935 0.70659232 -1.3136176e-08 -0.099706908 -0.099706908 -0.099706908 + 21510 2.151 0.70659506 0.70659388 -2.7663851e-09 -0.099707788 -0.099707788 -0.099707788 + 21520 2.152 0.70659661 0.70659543 7.3429794e-09 -0.099708665 -0.099708665 -0.099708665 + 21530 2.153 0.70659816 0.70659698 1.6960479e-08 -0.09970954 -0.09970954 -0.09970954 + 21540 2.154 0.70659971 0.70659852 2.5866671e-08 -0.099710413 -0.099710413 -0.099710413 + 21550 2.155 0.70660125 0.70660005 3.3859113e-08 -0.099711282 -0.099711282 -0.099711282 + 21560 2.156 0.70660279 0.70660158 4.075696e-08 -0.09971215 -0.09971215 -0.09971215 + 21570 2.157 0.70660433 0.7066031 4.6405059e-08 -0.099713014 -0.099713014 -0.099713014 + 21580 2.158 0.70660586 0.70660462 5.0677431e-08 -0.099713876 -0.099713876 -0.099713876 + 21590 2.159 0.70660739 0.70660613 5.3480079e-08 -0.099714735 -0.099714735 -0.099714735 + 21600 2.16 0.70660891 0.70660764 5.4753051e-08 -0.099715592 -0.099715592 -0.099715592 + 21610 2.161 0.70661043 0.70660914 5.4471716e-08 -0.099716446 -0.099716446 -0.099716446 + 21620 2.162 0.70661194 0.70661064 5.2647221e-08 -0.099717297 -0.099717297 -0.099717297 + 21630 2.163 0.70661345 0.70661214 4.9326131e-08 -0.099718146 -0.099718146 -0.099718146 + 21640 2.164 0.70661495 0.70661363 4.4589249e-08 -0.099718992 -0.099718992 -0.099718992 + 21650 2.165 0.70661645 0.70661511 3.8549661e-08 -0.099719836 -0.099719836 -0.099719836 + 21660 2.166 0.70661794 0.7066166 3.1350035e-08 -0.099720677 -0.099720677 -0.099720677 + 21670 2.167 0.70661943 0.70661808 2.3159262e-08 -0.099721516 -0.099721516 -0.099721516 + 21680 2.168 0.70662091 0.70661955 1.4168493e-08 -0.099722352 -0.099722352 -0.099722352 + 21690 2.169 0.70662239 0.70662103 4.5866794e-09 -0.099723185 -0.099723185 -0.099723185 + 21700 2.17 0.70662386 0.70662249 -5.3642766e-09 -0.099724016 -0.099724016 -0.099724016 + 21710 2.171 0.70662533 0.70662396 -1.5454661e-08 -0.099724845 -0.099724845 -0.099724845 + 21720 2.172 0.70662679 0.70662542 -2.545225e-08 -0.099725671 -0.099725671 -0.099725671 + 21730 2.173 0.70662824 0.70662688 -3.5127648e-08 -0.099726495 -0.099726495 -0.099726495 + 21740 2.174 0.70662969 0.70662834 -4.4259555e-08 -0.099727316 -0.099727316 -0.099727316 + 21750 2.175 0.70663114 0.70662979 -5.263982e-08 -0.099728134 -0.099728134 -0.099728134 + 21760 2.176 0.70663258 0.70663124 -6.007819e-08 -0.09972895 -0.09972895 -0.09972895 + 21770 2.177 0.70663401 0.70663268 -6.640662e-08 -0.099729764 -0.099729764 -0.099729764 + 21780 2.178 0.70663544 0.70663412 -7.1483074e-08 -0.099730575 -0.099730575 -0.099730575 + 21790 2.179 0.70663686 0.70663556 -7.5194702e-08 -0.099731384 -0.099731384 -0.099731384 + 21800 2.18 0.70663828 0.70663699 -7.7460351e-08 -0.09973219 -0.09973219 -0.09973219 + 21810 2.181 0.7066397 0.70663842 -7.8232334e-08 -0.099732994 -0.099732994 -0.099732994 + 21820 2.182 0.70664111 0.70663985 -7.7497419e-08 -0.099733795 -0.099733795 -0.099733795 + 21830 2.183 0.70664251 0.70664127 -7.5277035e-08 -0.099734594 -0.099734594 -0.099734594 + 21840 2.184 0.70664392 0.70664268 -7.1626675e-08 -0.099735391 -0.099735391 -0.099735391 + 21850 2.185 0.70664531 0.70664409 -6.6634516e-08 -0.099736185 -0.099736185 -0.099736185 + 21860 2.186 0.70664671 0.7066455 -6.0419295e-08 -0.099736976 -0.099736976 -0.099736976 + 21870 2.187 0.7066481 0.7066469 -5.3127493e-08 -0.099737766 -0.099737766 -0.099737766 + 21880 2.188 0.70664949 0.70664829 -4.4929882e-08 -0.099738553 -0.099738553 -0.099738553 + 21890 2.189 0.70665087 0.70664969 -3.6017529e-08 -0.099739337 -0.099739337 -0.099739337 + 21900 2.19 0.70665226 0.70665107 -2.6597349e-08 -0.099740119 -0.099740119 -0.099740119 + 21910 2.191 0.70665363 0.70665245 -1.6887299e-08 -0.099740899 -0.099740899 -0.099740899 + 21920 2.192 0.70665501 0.70665383 -7.1113393e-09 -0.099741677 -0.099741677 -0.099741677 + 21930 2.193 0.70665638 0.7066552 2.5057297e-09 -0.099742452 -0.099742452 -0.099742452 + 21940 2.194 0.70665775 0.70665656 1.1743436e-08 -0.099743224 -0.099743224 -0.099743224 + 21950 2.195 0.70665912 0.70665792 2.0390686e-08 -0.099743995 -0.099743995 -0.099743995 + 21960 2.196 0.70666048 0.70665928 2.8250591e-08 -0.099744763 -0.099744763 -0.099744763 + 21970 2.197 0.70666184 0.70666063 3.5144941e-08 -0.099745529 -0.099745529 -0.099745529 + 21980 2.198 0.7066632 0.70666197 4.0918251e-08 -0.099746292 -0.099746292 -0.099746292 + 21990 2.199 0.70666455 0.70666331 4.5441257e-08 -0.099747053 -0.099747053 -0.099747053 + 22000 2.2 0.7066659 0.70666465 4.8613813e-08 -0.099747812 -0.099747812 -0.099747812 + 22010 2.201 0.70666724 0.70666598 5.0367102e-08 -0.099748569 -0.099748569 -0.099748569 + 22020 2.202 0.70666858 0.70666731 5.0665122e-08 -0.099749323 -0.099749323 -0.099749323 + 22030 2.203 0.70666992 0.70666863 4.9505415e-08 -0.099750075 -0.099750075 -0.099750075 + 22040 2.204 0.70667125 0.70666995 4.6919025e-08 -0.099750825 -0.099750825 -0.099750825 + 22050 2.205 0.70667258 0.70667126 4.2969679e-08 -0.099751572 -0.099751572 -0.099751572 + 22060 2.206 0.7066739 0.70667258 3.7752229e-08 -0.099752317 -0.099752317 -0.099752317 + 22070 2.207 0.70667522 0.70667389 3.1390377e-08 -0.09975306 -0.09975306 -0.09975306 + 22080 2.208 0.70667654 0.70667519 2.4033745e-08 -0.099753801 -0.099753801 -0.099753801 + 22090 2.209 0.70667785 0.70667649 1.5854363e-08 -0.099754539 -0.099754539 -0.099754539 + 22100 2.21 0.70667915 0.70667779 7.0426432e-09 -0.099755275 -0.099755275 -0.099755275 + 22110 2.211 0.70668045 0.70667909 -2.1970451e-09 -0.099756009 -0.099756009 -0.099756009 + 22120 2.212 0.70668175 0.70668038 -1.1651116e-08 -0.099756741 -0.099756741 -0.099756741 + 22130 2.213 0.70668304 0.70668168 -2.1101702e-08 -0.09975747 -0.09975747 -0.09975747 + 22140 2.214 0.70668432 0.70668296 -3.0331671e-08 -0.099758198 -0.099758198 -0.099758198 + 22150 2.215 0.7066856 0.70668425 -3.9129616e-08 -0.099758923 -0.099758923 -0.099758923 + 22160 2.216 0.70668688 0.70668553 -4.7294692e-08 -0.099759646 -0.099759646 -0.099759646 + 22170 2.217 0.70668815 0.70668681 -5.4641202e-08 -0.099760366 -0.099760366 -0.099760366 + 22180 2.218 0.70668941 0.70668809 -6.1002816e-08 -0.099761085 -0.099761085 -0.099761085 + 22190 2.219 0.70669068 0.70668936 -6.6236337e-08 -0.099761801 -0.099761801 -0.099761801 + 22200 2.22 0.70669193 0.70669063 -7.0224917e-08 -0.099762515 -0.099762515 -0.099762515 + 22210 2.221 0.70669319 0.70669189 -7.2880669e-08 -0.099763227 -0.099763227 -0.099763227 + 22220 2.222 0.70669444 0.70669316 -7.4146593e-08 -0.099763937 -0.099763937 -0.099763937 + 22230 2.223 0.70669568 0.70669441 -7.3997797e-08 -0.099764645 -0.099764645 -0.099764645 + 22240 2.224 0.70669692 0.70669567 -7.2441969e-08 -0.099765351 -0.099765351 -0.099765351 + 22250 2.225 0.70669816 0.70669692 -6.9519106e-08 -0.099766054 -0.099766054 -0.099766054 + 22260 2.226 0.7066994 0.70669817 -6.5300494e-08 -0.099766755 -0.099766755 -0.099766755 + 22270 2.227 0.70670063 0.70669941 -5.9886979e-08 -0.099767455 -0.099767455 -0.099767455 + 22280 2.228 0.70670185 0.70670064 -5.3406557e-08 -0.099768152 -0.099768152 -0.099768152 + 22290 2.229 0.70670308 0.70670188 -4.6011356e-08 -0.099768847 -0.099768847 -0.099768847 + 22300 2.23 0.7067043 0.70670311 -3.7874064e-08 -0.09976954 -0.09976954 -0.09976954 + 22310 2.231 0.70670552 0.70670433 -2.9183898e-08 -0.09977023 -0.09977023 -0.09977023 + 22320 2.232 0.70670674 0.70670555 -2.0142212e-08 -0.099770919 -0.099770919 -0.099770919 + 22330 2.233 0.70670795 0.70670676 -1.0957829e-08 -0.099771606 -0.099771606 -0.099771606 + 22340 2.234 0.70670916 0.70670797 -1.8422197e-09 -0.09977229 -0.09977229 -0.09977229 + 22350 2.235 0.70671037 0.70670918 6.9953612e-09 -0.099772972 -0.099772972 -0.099772972 + 22360 2.236 0.70671158 0.70671038 1.5352679e-08 -0.099773653 -0.099773653 -0.099773653 + 22370 2.237 0.70671278 0.70671158 2.3039146e-08 -0.099774331 -0.099774331 -0.099774331 + 22380 2.238 0.70671398 0.70671277 2.9880161e-08 -0.099775007 -0.099775007 -0.099775007 + 22390 2.239 0.70671518 0.70671396 3.572108e-08 -0.099775682 -0.099775682 -0.099775682 + 22400 2.24 0.70671638 0.70671514 4.0430705e-08 -0.099776354 -0.099776354 -0.099776354 + 22410 2.241 0.70671757 0.70671632 4.3904229e-08 -0.099777024 -0.099777024 -0.099777024 + 22420 2.242 0.70671875 0.7067175 4.6065566e-08 -0.099777692 -0.099777692 -0.099777692 + 22430 2.243 0.70671994 0.70671867 4.6869011e-08 -0.099778358 -0.099778358 -0.099778358 + 22440 2.244 0.70672112 0.70671984 4.6300201e-08 -0.099779022 -0.099779022 -0.099779022 + 22450 2.245 0.7067223 0.706721 4.4376349e-08 -0.099779684 -0.099779684 -0.099779684 + 22460 2.246 0.70672347 0.70672216 4.1145753e-08 -0.099780344 -0.099780344 -0.099780344 + 22470 2.247 0.70672464 0.70672332 3.6686596e-08 -0.099781002 -0.099781002 -0.099781002 + 22480 2.248 0.70672581 0.70672448 3.1105053e-08 -0.099781658 -0.099781658 -0.099781658 + 22490 2.249 0.70672697 0.70672563 2.4532774e-08 -0.099782313 -0.099782313 -0.099782313 + 22500 2.25 0.70672812 0.70672678 1.7123777e-08 -0.099782965 -0.099782965 -0.099782965 + 22510 2.251 0.70672928 0.70672792 9.0508418e-09 -0.099783615 -0.099783615 -0.099783615 + 22520 2.252 0.70673042 0.70672907 5.0148589e-10 -0.099784263 -0.099784263 -0.099784263 + 22530 2.253 0.70673157 0.70673021 -8.3263915e-09 -0.099784909 -0.099784909 -0.099784909 + 22540 2.254 0.70673271 0.70673135 -1.7229088e-08 -0.099785553 -0.099785553 -0.099785553 + 22550 2.255 0.70673384 0.70673249 -2.6001795e-08 -0.099786196 -0.099786196 -0.099786196 + 22560 2.256 0.70673497 0.70673362 -3.444331e-08 -0.099786836 -0.099786836 -0.099786836 + 22570 2.257 0.7067361 0.70673475 -4.2360648e-08 -0.099787474 -0.099787474 -0.099787474 + 22580 2.258 0.70673722 0.70673588 -4.9573453e-08 -0.099788111 -0.099788111 -0.099788111 + 22590 2.259 0.70673834 0.70673701 -5.59181e-08 -0.099788745 -0.099788745 -0.099788745 + 22600 2.26 0.70673945 0.70673813 -6.125141e-08 -0.099789378 -0.099789378 -0.099789378 + 22610 2.261 0.70674056 0.70673926 -6.5453878e-08 -0.099790009 -0.099790009 -0.099790009 + 22620 2.262 0.70674167 0.70674037 -6.8432344e-08 -0.099790638 -0.099790638 -0.099790638 + 22630 2.263 0.70674277 0.70674149 -7.0122059e-08 -0.099791264 -0.099791264 -0.099791264 + 22640 2.264 0.70674387 0.7067426 -7.0488084e-08 -0.099791889 -0.099791889 -0.099791889 + 22650 2.265 0.70674497 0.70674371 -6.9526007e-08 -0.099792513 -0.099792513 -0.099792513 + 22660 2.266 0.70674606 0.70674481 -6.7261947e-08 -0.099793134 -0.099793134 -0.099793134 + 22670 2.267 0.70674715 0.70674591 -6.3751866e-08 -0.099793753 -0.099793753 -0.099793753 + 22680 2.268 0.70674824 0.70674701 -5.9080192e-08 -0.099794371 -0.099794371 -0.099794371 + 22690 2.269 0.70674932 0.70674811 -5.3357793e-08 -0.099794986 -0.099794986 -0.099794986 + 22700 2.27 0.7067504 0.70674919 -4.6719347e-08 -0.0997956 -0.0997956 -0.0997956 + 22710 2.271 0.70675148 0.70675028 -3.932018e-08 -0.099796212 -0.099796212 -0.099796212 + 22720 2.272 0.70675256 0.70675136 -3.133263e-08 -0.099796822 -0.099796822 -0.099796822 + 22730 2.273 0.70675363 0.70675244 -2.2942037e-08 -0.09979743 -0.09979743 -0.09979743 + 22740 2.274 0.70675471 0.70675351 -1.4342445e-08 -0.099798036 -0.099798036 -0.099798036 + 22750 2.275 0.70675578 0.70675458 -5.7321139e-09 -0.099798641 -0.099798641 -0.099798641 + 22760 2.276 0.70675684 0.70675565 2.6910464e-09 -0.099799243 -0.099799243 -0.099799243 + 22770 2.277 0.70675791 0.70675671 1.0734025e-08 -0.099799844 -0.099799844 -0.099799844 + 22780 2.278 0.70675897 0.70675776 1.8213131e-08 -0.099800443 -0.099800443 -0.099800443 + 22790 2.279 0.70676003 0.70675881 2.4958185e-08 -0.099801041 -0.099801041 -0.099801041 + 22800 2.28 0.70676109 0.70675986 3.0816393e-08 -0.099801636 -0.099801636 -0.099801636 + 22810 2.281 0.70676214 0.70676091 3.5655801e-08 -0.09980223 -0.09980223 -0.09980223 + 22820 2.282 0.70676319 0.70676195 3.9368268e-08 -0.099802821 -0.099802821 -0.099802821 + 22830 2.283 0.70676424 0.70676299 4.187188e-08 -0.099803411 -0.099803411 -0.099803411 + 22840 2.284 0.70676529 0.70676402 4.3112749e-08 -0.099804 -0.099804 -0.099804 + 22850 2.285 0.70676633 0.70676505 4.3066173e-08 -0.099804586 -0.099804586 -0.099804586 + 22860 2.286 0.70676737 0.70676608 4.1737109e-08 -0.099805171 -0.099805171 -0.099805171 + 22870 2.287 0.70676841 0.70676711 3.9159976e-08 -0.099805754 -0.099805754 -0.099805754 + 22880 2.288 0.70676944 0.70676813 3.5397772e-08 -0.099806335 -0.099806335 -0.099806335 + 22890 2.289 0.70677047 0.70676915 3.054054e-08 -0.099806914 -0.099806914 -0.099806914 + 22900 2.29 0.7067715 0.70677017 2.4703217e-08 -0.099807492 -0.099807492 -0.099807492 + 22910 2.291 0.70677252 0.70677118 1.802292e-08 -0.099808068 -0.099808068 -0.099808068 + 22920 2.292 0.70677354 0.70677219 1.0655723e-08 -0.099808642 -0.099808642 -0.099808642 + 22930 2.293 0.70677455 0.7067732 2.7730173e-09 -0.099809214 -0.099809214 -0.099809214 + 22940 2.294 0.70677556 0.70677421 -5.4424759e-09 -0.099809785 -0.099809785 -0.099809785 + 22950 2.295 0.70677657 0.70677522 -1.3800939e-08 -0.099810354 -0.099810354 -0.099810354 + 22960 2.296 0.70677757 0.70677622 -2.210984e-08 -0.099810921 -0.099810921 -0.099810921 + 22970 2.297 0.70677857 0.70677722 -3.0178368e-08 -0.099811486 -0.099811486 -0.099811486 + 22980 2.298 0.70677957 0.70677822 -3.7821814e-08 -0.09981205 -0.09981205 -0.09981205 + 22990 2.299 0.70678056 0.70677922 -4.4865793e-08 -0.099812612 -0.099812612 -0.099812612 + 23000 2.3 0.70678154 0.70678021 -5.1150227e-08 -0.099813172 -0.099813172 -0.099813172 + 23010 2.301 0.70678253 0.70678121 -5.6532976e-08 -0.099813731 -0.099813731 -0.099813731 + 23020 2.302 0.70678351 0.7067822 -6.0893052e-08 -0.099814288 -0.099814288 -0.099814288 + 23030 2.303 0.70678448 0.70678318 -6.4133338e-08 -0.099814843 -0.099814843 -0.099814843 + 23040 2.304 0.70678546 0.70678417 -6.6182745e-08 -0.099815397 -0.099815397 -0.099815397 + 23050 2.305 0.70678643 0.70678515 -6.6997771e-08 -0.099815949 -0.099815949 -0.099815949 + 23060 2.306 0.7067874 0.70678613 -6.6563413e-08 -0.099816499 -0.099816499 -0.099816499 + 23070 2.307 0.70678836 0.70678711 -6.4893431e-08 -0.099817048 -0.099817048 -0.099817048 + 23080 2.308 0.70678932 0.70678808 -6.2029939e-08 -0.099817595 -0.099817595 -0.099817595 + 23090 2.309 0.70679028 0.70678905 -5.8042357e-08 -0.09981814 -0.09981814 -0.09981814 + 23100 2.31 0.70679124 0.70679001 -5.3025731e-08 -0.099818684 -0.099818684 -0.099818684 + 23110 2.311 0.70679219 0.70679098 -4.7098472e-08 -0.099819226 -0.099819226 -0.099819226 + 23120 2.312 0.70679315 0.70679194 -4.039956e-08 -0.099819766 -0.099819766 -0.099819766 + 23130 2.313 0.7067941 0.70679289 -3.3085295e-08 -0.099820305 -0.099820305 -0.099820305 + 23140 2.314 0.70679504 0.70679384 -2.5325644e-08 -0.099820842 -0.099820842 -0.099820842 + 23150 2.315 0.70679599 0.70679479 -1.7300302e-08 -0.099821377 -0.099821377 -0.099821377 + 23160 2.316 0.70679693 0.70679573 -9.1945247e-09 -0.099821911 -0.099821911 -0.099821911 + 23170 2.317 0.70679788 0.70679667 -1.1948586e-09 -0.099822443 -0.099822443 -0.099822443 + 23180 2.318 0.70679882 0.70679761 6.5151521e-09 -0.099822974 -0.099822974 -0.099822974 + 23190 2.319 0.70679975 0.70679854 1.3759175e-08 -0.099823503 -0.099823503 -0.099823503 + 23200 2.32 0.70680069 0.70679947 2.037212e-08 -0.09982403 -0.09982403 -0.09982403 + 23210 2.321 0.70680162 0.7068004 2.6203901e-08 -0.099824556 -0.099824556 -0.099824556 + 23220 2.322 0.70680256 0.70680132 3.112284e-08 -0.09982508 -0.09982508 -0.09982508 + 23230 2.323 0.70680348 0.70680224 3.5018635e-08 -0.099825603 -0.099825603 -0.099825603 + 23240 2.324 0.70680441 0.70680316 3.7804836e-08 -0.099826124 -0.099826124 -0.099826124 + 23250 2.325 0.70680534 0.70680407 3.9420758e-08 -0.099826643 -0.099826643 -0.099826643 + 23260 2.326 0.70680626 0.70680498 3.9832795e-08 -0.099827161 -0.099827161 -0.099827161 + 23270 2.327 0.70680718 0.70680589 3.9035115e-08 -0.099827677 -0.099827677 -0.099827677 + 23280 2.328 0.70680809 0.70680679 3.7049709e-08 -0.099828192 -0.099828192 -0.099828192 + 23290 2.329 0.706809 0.7068077 3.3925798e-08 -0.099828705 -0.099828705 -0.099828705 + 23300 2.33 0.70680991 0.7068086 2.9738627e-08 -0.099829217 -0.099829217 -0.099829217 + 23310 2.331 0.70681082 0.70680949 2.4587649e-08 -0.099829727 -0.099829727 -0.099829727 + 23320 2.332 0.70681172 0.70681039 1.8594173e-08 -0.099830235 -0.099830235 -0.099830235 + 23330 2.333 0.70681262 0.70681128 1.1898502e-08 -0.099830742 -0.099830742 -0.099830742 + 23340 2.334 0.70681352 0.70681218 4.6566595e-09 -0.099831248 -0.099831248 -0.099831248 + 23350 2.335 0.70681441 0.70681306 -2.9632507e-09 -0.099831752 -0.099831752 -0.099831752 + 23360 2.336 0.7068153 0.70681395 -1.0784942e-08 -0.099832254 -0.099832254 -0.099832254 + 23370 2.337 0.70681619 0.70681484 -1.8628022e-08 -0.099832755 -0.099832755 -0.099832755 + 23380 2.338 0.70681707 0.70681572 -2.6312152e-08 -0.099833254 -0.099833254 -0.099833254 + 23390 2.339 0.70681795 0.70681661 -3.3661192e-08 -0.099833752 -0.099833752 -0.099833752 + 23400 2.34 0.70681882 0.70681749 -4.0507233e-08 -0.099834249 -0.099834249 -0.099834249 + 23410 2.341 0.70681969 0.70681836 -4.669444e-08 -0.099834743 -0.099834743 -0.099834743 + 23420 2.342 0.70682056 0.70681924 -5.2082587e-08 -0.099835237 -0.099835237 -0.099835237 + 23430 2.343 0.70682143 0.70682012 -5.6550242e-08 -0.099835729 -0.099835729 -0.099835729 + 23440 2.344 0.70682229 0.70682099 -5.9997496e-08 -0.099836219 -0.099836219 -0.099836219 + 23450 2.345 0.70682315 0.70682186 -6.2348197e-08 -0.099836708 -0.099836708 -0.099836708 + 23460 2.346 0.70682401 0.70682272 -6.3551627e-08 -0.099837195 -0.099837195 -0.099837195 + 23470 2.347 0.70682486 0.70682359 -6.3583594e-08 -0.099837681 -0.099837681 -0.099837681 + 23480 2.348 0.70682571 0.70682445 -6.2446904e-08 -0.099838165 -0.099838165 -0.099838165 + 23490 2.349 0.70682656 0.70682531 -6.0171218e-08 -0.099838648 -0.099838648 -0.099838648 + 23500 2.35 0.70682741 0.70682617 -5.6812289e-08 -0.09983913 -0.09983913 -0.09983913 + 23510 2.351 0.70682825 0.70682702 -5.2450599e-08 -0.09983961 -0.09983961 -0.09983961 + 23520 2.352 0.70682909 0.70682787 -4.7189438e-08 -0.099840089 -0.099840089 -0.099840089 + 23530 2.353 0.70682993 0.70682872 -4.115246e-08 -0.099840566 -0.099840566 -0.099840566 + 23540 2.354 0.70683077 0.70682956 -3.4480775e-08 -0.099841041 -0.099841041 -0.099841041 + 23550 2.355 0.70683161 0.7068304 -2.732966e-08 -0.099841516 -0.099841516 -0.099841516 + 23560 2.356 0.70683244 0.70683124 -1.9864941e-08 -0.099841988 -0.099841988 -0.099841988 + 23570 2.357 0.70683328 0.70683207 -1.2259152e-08 -0.09984246 -0.09984246 -0.09984246 + 23580 2.358 0.70683411 0.7068329 -4.6875496e-09 -0.09984293 -0.09984293 -0.09984293 + 23590 2.359 0.70683494 0.70683373 2.675926e-09 -0.099843398 -0.099843398 -0.099843398 + 23600 2.36 0.70683577 0.70683456 9.6626439e-09 -0.099843865 -0.099843865 -0.099843865 + 23610 2.361 0.70683659 0.70683538 1.6113143e-08 -0.099844331 -0.099844331 -0.099844331 + 23620 2.362 0.70683742 0.70683619 2.188077e-08 -0.099844795 -0.099844795 -0.099844795 + 23630 2.363 0.70683824 0.70683701 2.6835011e-08 -0.099845258 -0.099845258 -0.099845258 + 23640 2.364 0.70683906 0.70683782 3.0864443e-08 -0.09984572 -0.09984572 -0.09984572 + 23650 2.365 0.70683988 0.70683863 3.387924e-08 -0.09984618 -0.09984618 -0.09984618 + 23660 2.366 0.7068407 0.70683944 3.5813168e-08 -0.099846639 -0.099846639 -0.099846639 + 23670 2.367 0.70684151 0.70684024 3.6625041e-08 -0.099847096 -0.099847096 -0.099847096 + 23680 2.368 0.70684232 0.70684104 3.6299589e-08 -0.099847552 -0.099847552 -0.099847552 + 23690 2.369 0.70684313 0.70684184 3.484773e-08 -0.099848006 -0.099848006 -0.099848006 + 23700 2.37 0.70684394 0.70684263 3.2306245e-08 -0.099848459 -0.099848459 -0.099848459 + 23710 2.371 0.70684474 0.70684343 2.8736849e-08 -0.099848911 -0.099848911 -0.099848911 + 23720 2.372 0.70684554 0.70684422 2.42247e-08 -0.099849362 -0.099849362 -0.099849362 + 23730 2.373 0.70684634 0.70684501 1.8876368e-08 -0.099849811 -0.099849811 -0.099849811 + 23740 2.374 0.70684713 0.7068458 1.2817326e-08 -0.099850258 -0.099850258 -0.099850258 + 23750 2.375 0.70684793 0.70684659 6.1890013e-09 -0.099850705 -0.099850705 -0.099850705 + 23760 2.376 0.70684871 0.70684737 -8.5451703e-10 -0.09985115 -0.09985115 -0.09985115 + 23770 2.377 0.7068495 0.70684816 -8.1500628e-09 -0.099851593 -0.099851593 -0.099851593 + 23780 2.378 0.70685028 0.70684894 -1.5529169e-08 -0.099852036 -0.099852036 -0.099852036 + 23790 2.379 0.70685106 0.70684972 -2.2821957e-08 -0.099852477 -0.099852477 -0.099852477 + 23800 2.38 0.70685184 0.7068505 -2.9861045e-08 -0.099852916 -0.099852916 -0.099852916 + 23810 2.381 0.70685261 0.70685128 -3.6485391e-08 -0.099853355 -0.099853355 -0.099853355 + 23820 2.382 0.70685338 0.70685205 -4.254397e-08 -0.099853791 -0.099853791 -0.099853791 + 23830 2.383 0.70685415 0.70685283 -4.7899223e-08 -0.099854227 -0.099854227 -0.099854227 + 23840 2.384 0.70685491 0.7068536 -5.2430172e-08 -0.099854661 -0.099854661 -0.099854661 + 23850 2.385 0.70685567 0.70685437 -5.6035154e-08 -0.099855094 -0.099855094 -0.099855094 + 23860 2.386 0.70685643 0.70685514 -5.8634099e-08 -0.099855526 -0.099855526 -0.099855526 + 23870 2.387 0.70685719 0.7068559 -6.0170307e-08 -0.099855956 -0.099855956 -0.099855956 + 23880 2.388 0.70685794 0.70685667 -6.0611676e-08 -0.099856386 -0.099856386 -0.099856386 + 23890 2.389 0.70685869 0.70685743 -5.9951373e-08 -0.099856813 -0.099856813 -0.099856813 + 23900 2.39 0.70685944 0.70685819 -5.8207909e-08 -0.09985724 -0.09985724 -0.09985724 + 23910 2.391 0.70686019 0.70685894 -5.5424637e-08 -0.099857665 -0.099857665 -0.099857665 + 23920 2.392 0.70686093 0.7068597 -5.1668687e-08 -0.099858089 -0.099858089 -0.099858089 + 23930 2.393 0.70686168 0.70686045 -4.702934e-08 -0.099858511 -0.099858511 -0.099858511 + 23940 2.394 0.70686242 0.7068612 -4.1615921e-08 -0.099858933 -0.099858933 -0.099858933 + 23950 2.395 0.70686316 0.70686194 -3.5555213e-08 -0.099859353 -0.099859353 -0.099859353 + 23960 2.396 0.7068639 0.70686269 -2.8988501e-08 -0.099859772 -0.099859772 -0.099859772 + 23970 2.397 0.70686463 0.70686342 -2.2068273e-08 -0.099860189 -0.099860189 -0.099860189 + 23980 2.398 0.70686537 0.70686416 -1.4954682e-08 -0.099860605 -0.099860605 -0.099860605 + 23990 2.399 0.7068661 0.7068649 -7.8118434e-09 -0.09986102 -0.09986102 -0.09986102 + 24000 2.4 0.70686684 0.70686563 -8.0404842e-10 -0.099861434 -0.099861434 -0.099861434 + 24010 2.401 0.70686757 0.70686635 5.9080126e-09 -0.099861847 -0.099861847 -0.099861847 + 24020 2.402 0.7068683 0.70686708 1.2170934e-08 -0.099862258 -0.099862258 -0.099862258 + 24030 2.403 0.70686902 0.7068678 1.7842097e-08 -0.099862668 -0.099862668 -0.099862668 + 24040 2.404 0.70686975 0.70686852 2.2792921e-08 -0.099863077 -0.099863077 -0.099863077 + 24050 2.405 0.70687048 0.70686924 2.6911771e-08 -0.099863484 -0.099863484 -0.099863484 + 24060 2.406 0.7068712 0.70686995 3.0106476e-08 -0.09986389 -0.09986389 -0.09986389 + 24070 2.407 0.70687192 0.70687066 3.2306389e-08 -0.099864295 -0.099864295 -0.099864295 + 24080 2.408 0.70687264 0.70687137 3.3463945e-08 -0.099864699 -0.099864699 -0.099864699 + 24090 2.409 0.70687336 0.70687208 3.3555687e-08 -0.099865102 -0.099865102 -0.099865102 + 24100 2.41 0.70687407 0.70687278 3.2582728e-08 -0.099865503 -0.099865503 -0.099865503 + 24110 2.411 0.70687478 0.70687349 3.0570656e-08 -0.099865903 -0.099865903 -0.099865903 + 24120 2.412 0.70687549 0.70687419 2.756887e-08 -0.099866302 -0.099866302 -0.099866302 + 24130 2.413 0.7068762 0.70687489 2.3649372e-08 -0.0998667 -0.0998667 -0.0998667 + 24140 2.414 0.70687691 0.70687558 1.8905042e-08 -0.099867096 -0.099867096 -0.099867096 + 24150 2.415 0.70687761 0.70687628 1.3447443e-08 -0.099867492 -0.099867492 -0.099867492 + 24160 2.416 0.70687831 0.70687697 7.4041986e-09 -0.099867886 -0.099867886 -0.099867886 + 24170 2.417 0.706879 0.70687767 9.1600922e-10 -0.099868279 -0.099868279 -0.099868279 + 24180 2.418 0.7068797 0.70687836 -5.866621e-09 -0.099868671 -0.099868671 -0.099868671 + 24190 2.419 0.70688039 0.70687905 -1.2786874e-08 -0.099869061 -0.099869061 -0.099869061 + 24200 2.42 0.70688108 0.70687974 -1.9685241e-08 -0.09986945 -0.09986945 -0.09986945 + 24210 2.421 0.70688176 0.70688043 -2.6403201e-08 -0.099869839 -0.099869839 -0.099869839 + 24220 2.422 0.70688244 0.70688111 -3.2786856e-08 -0.099870226 -0.099870226 -0.099870226 + 24230 2.423 0.70688312 0.7068818 -3.8690462e-08 -0.099870611 -0.099870611 -0.099870611 + 24240 2.424 0.7068838 0.70688248 -4.3979751e-08 -0.099870996 -0.099870996 -0.099870996 + 24250 2.425 0.70688448 0.70688316 -4.8534982e-08 -0.09987138 -0.09987138 -0.09987138 + 24260 2.426 0.70688515 0.70688384 -5.2253654e-08 -0.099871762 -0.099871762 -0.099871762 + 24270 2.427 0.70688582 0.70688452 -5.5052807e-08 -0.099872143 -0.099872143 -0.099872143 + 24280 2.428 0.70688648 0.7068852 -5.6870872e-08 -0.099872523 -0.099872523 -0.099872523 + 24290 2.429 0.70688715 0.70688587 -5.7669019e-08 -0.099872902 -0.099872902 -0.099872902 + 24300 2.43 0.70688781 0.70688654 -5.7431987e-08 -0.09987328 -0.09987328 -0.09987328 + 24310 2.431 0.70688847 0.70688722 -5.6168356e-08 -0.099873656 -0.099873656 -0.099873656 + 24320 2.432 0.70688913 0.70688788 -5.3910283e-08 -0.099874032 -0.099874032 -0.099874032 + 24330 2.433 0.70688979 0.70688855 -5.071269e-08 -0.099874406 -0.099874406 -0.099874406 + 24340 2.434 0.70689045 0.70688921 -4.6651932e-08 -0.099874779 -0.099874779 -0.099874779 + 24350 2.435 0.7068911 0.70688987 -4.1823977e-08 -0.099875151 -0.099875151 -0.099875151 + 24360 2.436 0.70689175 0.70689053 -3.6342143e-08 -0.099875522 -0.099875522 -0.099875522 + 24370 2.437 0.70689241 0.70689119 -3.0334435e-08 -0.099875892 -0.099875892 -0.099875892 + 24380 2.438 0.70689306 0.70689184 -2.3940563e-08 -0.099876261 -0.099876261 -0.099876261 + 24390 2.439 0.70689371 0.70689249 -1.730869e-08 -0.099876628 -0.099876628 -0.099876628 + 24400 2.44 0.70689435 0.70689314 -1.0592007e-08 -0.099876995 -0.099876995 -0.099876995 + 24410 2.441 0.706895 0.70689379 -3.945187e-09 -0.09987736 -0.09987736 -0.09987736 + 24420 2.442 0.70689565 0.70689443 2.4791681e-09 -0.099877724 -0.099877724 -0.099877724 + 24430 2.443 0.70689629 0.70689507 8.5340334e-09 -0.099878087 -0.099878087 -0.099878087 + 24440 2.444 0.70689693 0.70689571 1.4081323e-08 -0.099878449 -0.099878449 -0.099878449 + 24450 2.445 0.70689757 0.70689634 1.8995038e-08 -0.09987881 -0.09987881 -0.09987881 + 24460 2.446 0.70689821 0.70689698 2.3164127e-08 -0.09987917 -0.09987917 -0.09987917 + 24470 2.447 0.70689885 0.70689761 2.6494993e-08 -0.099879529 -0.099879529 -0.099879529 + 24480 2.448 0.70689949 0.70689823 2.8913594e-08 -0.099879887 -0.099879887 -0.099879887 + 24490 2.449 0.70690012 0.70689886 3.0367085e-08 -0.099880243 -0.099880243 -0.099880243 + 24500 2.45 0.70690076 0.70689948 3.0824969e-08 -0.099880599 -0.099880599 -0.099880599 + 24510 2.451 0.70690139 0.70690011 3.0279732e-08 -0.099880953 -0.099880953 -0.099880953 + 24520 2.452 0.70690202 0.70690073 2.8746944e-08 -0.099881306 -0.099881306 -0.099881306 + 24530 2.453 0.70690265 0.70690134 2.6264834e-08 -0.099881659 -0.099881659 -0.099881659 + 24540 2.454 0.70690327 0.70690196 2.2893339e-08 -0.09988201 -0.09988201 -0.09988201 + 24550 2.455 0.70690389 0.70690258 1.8712663e-08 -0.09988236 -0.09988236 -0.09988236 + 24560 2.456 0.70690451 0.70690319 1.3821372e-08 -0.099882709 -0.099882709 -0.099882709 + 24570 2.457 0.70690513 0.7069038 8.3340722e-09 -0.099883057 -0.099883057 -0.099883057 + 24580 2.458 0.70690575 0.70690442 2.3787239e-09 -0.099883404 -0.099883404 -0.099883404 + 24590 2.459 0.70690636 0.70690503 -3.9063373e-09 -0.09988375 -0.09988375 -0.09988375 + 24600 2.46 0.70690697 0.70690564 -1.0375614e-08 -0.099884095 -0.099884095 -0.099884095 + 24610 2.461 0.70690758 0.70690624 -1.6879814e-08 -0.099884439 -0.099884439 -0.099884439 + 24620 2.462 0.70690818 0.70690685 -2.3269292e-08 -0.099884781 -0.099884781 -0.099884781 + 24630 2.463 0.70690879 0.70690746 -2.9397496e-08 -0.099885123 -0.099885123 -0.099885123 + 24640 2.464 0.70690939 0.70690806 -3.512432e-08 -0.099885464 -0.099885464 -0.099885464 + 24650 2.465 0.70690998 0.70690866 -4.0319315e-08 -0.099885803 -0.099885803 -0.099885803 + 24660 2.466 0.70691058 0.70690927 -4.486465e-08 -0.099886142 -0.099886142 -0.099886142 + 24670 2.467 0.70691117 0.70690987 -4.8657787e-08 -0.09988648 -0.09988648 -0.09988648 + 24680 2.468 0.70691176 0.70691047 -5.1613796e-08 -0.099886816 -0.099886816 -0.099886816 + 24690 2.469 0.70691235 0.70691106 -5.3667247e-08 -0.099887152 -0.099887152 -0.099887152 + 24700 2.47 0.70691294 0.70691166 -5.4773659e-08 -0.099887486 -0.099887486 -0.099887486 + 24710 2.471 0.70691353 0.70691225 -5.4910461e-08 -0.09988782 -0.09988782 -0.09988782 + 24720 2.472 0.70691411 0.70691285 -5.4077443e-08 -0.099888152 -0.099888152 -0.099888152 + 24730 2.473 0.70691469 0.70691344 -5.2296692e-08 -0.099888484 -0.099888484 -0.099888484 + 24740 2.474 0.70691527 0.70691403 -4.9612019e-08 -0.099888814 -0.099888814 -0.099888814 + 24750 2.475 0.70691585 0.70691461 -4.6087884e-08 -0.099889144 -0.099889144 -0.099889144 + 24760 2.476 0.70691643 0.7069152 -4.1807855e-08 -0.099889472 -0.099889472 -0.099889472 + 24770 2.477 0.706917 0.70691578 -3.6872624e-08 -0.0998898 -0.0998898 -0.0998898 + 24780 2.478 0.70691758 0.70691636 -3.1397643e-08 -0.099890126 -0.099890126 -0.099890126 + 24790 2.479 0.70691815 0.70691694 -2.5510426e-08 -0.099890452 -0.099890452 -0.099890452 + 24800 2.48 0.70691873 0.70691751 -1.9347578e-08 -0.099890777 -0.099890777 -0.099890777 + 24810 2.481 0.7069193 0.70691808 -1.3051629e-08 -0.0998911 -0.0998911 -0.0998911 + 24820 2.482 0.70691987 0.70691865 -6.767737e-09 -0.099891423 -0.099891423 -0.099891423 + 24830 2.483 0.70692044 0.70691922 -6.4034447e-10 -0.099891744 -0.099891744 -0.099891744 + 24840 2.484 0.70692101 0.70691979 5.1901416e-09 -0.099892065 -0.099892065 -0.099892065 + 24850 2.485 0.70692158 0.70692035 1.0590565e-08 -0.099892385 -0.099892385 -0.099892385 + 24860 2.486 0.70692214 0.70692091 1.5438062e-08 -0.099892703 -0.099892703 -0.099892703 + 24870 2.487 0.70692271 0.70692147 1.962285e-08 -0.099893021 -0.099893021 -0.099893021 + 24880 2.488 0.70692327 0.70692202 2.305072e-08 -0.099893338 -0.099893338 -0.099893338 + 24890 2.489 0.70692383 0.70692258 2.5645147e-08 -0.099893654 -0.099893654 -0.099893654 + 24900 2.49 0.70692439 0.70692313 2.7349003e-08 -0.099893968 -0.099893968 -0.099893968 + 24910 2.491 0.70692495 0.70692368 2.8125808e-08 -0.099894282 -0.099894282 -0.099894282 + 24920 2.492 0.70692551 0.70692423 2.7960507e-08 -0.099894595 -0.099894595 -0.099894595 + 24930 2.493 0.70692607 0.70692478 2.6859752e-08 -0.099894907 -0.099894907 -0.099894907 + 24940 2.494 0.70692662 0.70692532 2.4851683e-08 -0.099895218 -0.099895218 -0.099895218 + 24950 2.495 0.70692717 0.70692587 2.1985217e-08 -0.099895528 -0.099895528 -0.099895528 + 24960 2.496 0.70692772 0.70692641 1.8328859e-08 -0.099895838 -0.099895838 -0.099895838 + 24970 2.497 0.70692827 0.70692695 1.3969067e-08 -0.099896146 -0.099896146 -0.099896146 + 24980 2.498 0.70692882 0.70692749 9.0082126e-09 -0.099896453 -0.099896453 -0.099896453 + 24990 2.499 0.70692936 0.70692803 3.5621776e-09 -0.099896759 -0.099896759 -0.099896759 + 25000 2.5 0.7069299 0.70692857 -2.242352e-09 -0.099897065 -0.099897065 -0.099897065 + 25010 2.501 0.70693044 0.70692911 -8.2708303e-09 -0.099897369 -0.099897369 -0.099897369 + 25020 2.502 0.70693098 0.70692965 -1.438397e-08 -0.099897673 -0.099897673 -0.099897673 + 25030 2.503 0.70693151 0.70693018 -2.0440957e-08 -0.099897976 -0.099897976 -0.099897976 + 25040 2.504 0.70693205 0.70693072 -2.6302696e-08 -0.099898277 -0.099898277 -0.099898277 + 25050 2.505 0.70693258 0.70693125 -3.1835002e-08 -0.099898578 -0.099898578 -0.099898578 + 25060 2.506 0.7069331 0.70693178 -3.6911669e-08 -0.099898878 -0.099898878 -0.099898878 + 25070 2.507 0.70693363 0.70693232 -4.1417351e-08 -0.099899177 -0.099899177 -0.099899177 + 25080 2.508 0.70693415 0.70693285 -4.5250177e-08 -0.099899475 -0.099899475 -0.099899475 + 25090 2.509 0.70693468 0.70693338 -4.8324058e-08 -0.099899772 -0.099899772 -0.099899772 + 25100 2.51 0.7069352 0.7069339 -5.0570614e-08 -0.099900069 -0.099900069 -0.099900069 + 25110 2.511 0.70693571 0.70693443 -5.1940696e-08 -0.099900364 -0.099900364 -0.099900364 + 25120 2.512 0.70693623 0.70693495 -5.2405453e-08 -0.099900659 -0.099900659 -0.099900659 + 25130 2.513 0.70693675 0.70693548 -5.1956942e-08 -0.099900952 -0.099900952 -0.099900952 + 25140 2.514 0.70693726 0.706936 -5.0608239e-08 -0.099901245 -0.099901245 -0.099901245 + 25150 2.515 0.70693777 0.70693652 -4.8393082e-08 -0.099901537 -0.099901537 -0.099901537 + 25160 2.516 0.70693828 0.70693704 -4.5365025e-08 -0.099901828 -0.099901828 -0.099901828 + 25170 2.517 0.70693879 0.70693755 -4.1596156e-08 -0.099902118 -0.099902118 -0.099902118 + 25180 2.518 0.7069393 0.70693807 -3.7175374e-08 -0.099902407 -0.099902407 -0.099902407 + 25190 2.519 0.70693981 0.70693858 -3.2206301e-08 -0.099902695 -0.099902695 -0.099902695 + 25200 2.52 0.70694031 0.70693909 -2.6804852e-08 -0.099902983 -0.099902983 -0.099902983 + 25210 2.521 0.70694082 0.7069396 -2.1096532e-08 -0.099903269 -0.099903269 -0.099903269 + 25220 2.522 0.70694132 0.7069401 -1.5213525e-08 -0.099903555 -0.099903555 -0.099903555 + 25230 2.523 0.70694183 0.70694061 -9.2916271e-09 -0.09990384 -0.09990384 -0.09990384 + 25240 2.524 0.70694233 0.70694111 -3.4671218e-09 -0.099904124 -0.099904124 -0.099904124 + 25250 2.525 0.70694283 0.70694161 2.1263612e-09 -0.099904407 -0.099904407 -0.099904407 + 25260 2.526 0.70694333 0.70694211 7.3609082e-09 -0.099904689 -0.099904689 -0.099904689 + 25270 2.527 0.70694383 0.7069426 1.2117246e-08 -0.099904971 -0.099904971 -0.099904971 + 25280 2.528 0.70694433 0.70694309 1.6287457e-08 -0.099905251 -0.099905251 -0.099905251 + 25290 2.529 0.70694483 0.70694359 1.9777428e-08 -0.099905531 -0.099905531 -0.099905531 + 25300 2.53 0.70694533 0.70694407 2.2508973e-08 -0.09990581 -0.09990581 -0.09990581 + 25310 2.531 0.70694582 0.70694456 2.4421578e-08 -0.099906088 -0.099906088 -0.099906088 + 25320 2.532 0.70694632 0.70694505 2.5473747e-08 -0.099906365 -0.099906365 -0.099906365 + 25330 2.533 0.70694681 0.70694553 2.564389e-08 -0.099906641 -0.099906641 -0.099906641 + 25340 2.534 0.7069473 0.70694602 2.4930766e-08 -0.099906917 -0.099906917 -0.099906917 + 25350 2.535 0.70694779 0.7069465 2.3353447e-08 -0.099907191 -0.099907191 -0.099907191 + 25360 2.536 0.70694828 0.70694698 2.0950816e-08 -0.099907465 -0.099907465 -0.099907465 + 25370 2.537 0.70694876 0.70694746 1.7780618e-08 -0.099907738 -0.099907738 -0.099907738 + 25380 2.538 0.70694925 0.70694794 1.3918071e-08 -0.09990801 -0.09990801 -0.09990801 + 25390 2.539 0.70694973 0.70694841 9.4540864e-09 -0.099908281 -0.099908281 -0.099908281 + 25400 2.54 0.70695021 0.70694889 4.4931285e-09 -0.099908552 -0.099908552 -0.099908552 + 25410 2.541 0.70695069 0.70694936 -8.4922654e-10 -0.099908822 -0.099908822 -0.099908822 + 25420 2.542 0.70695117 0.70694984 -6.4489828e-09 -0.099909091 -0.099909091 -0.099909091 + 25430 2.543 0.70695164 0.70695031 -1.2176601e-08 -0.099909359 -0.099909359 -0.099909359 + 25440 2.544 0.70695211 0.70695078 -1.7899994e-08 -0.099909626 -0.099909626 -0.099909626 + 25450 2.545 0.70695258 0.70695126 -2.348757e-08 -0.099909892 -0.099909892 -0.099909892 + 25460 2.546 0.70695305 0.70695173 -2.8811262e-08 -0.099910158 -0.099910158 -0.099910158 + 25470 2.547 0.70695352 0.7069522 -3.3749454e-08 -0.099910423 -0.099910423 -0.099910423 + 25480 2.548 0.70695398 0.70695267 -3.8189766e-08 -0.099910687 -0.099910687 -0.099910687 + 25490 2.549 0.70695444 0.70695314 -4.2031604e-08 -0.09991095 -0.09991095 -0.09991095 + 25500 2.55 0.7069549 0.7069536 -4.5188441e-08 -0.099911212 -0.099911212 -0.099911212 + 25510 2.551 0.70695536 0.70695407 -4.7589763e-08 -0.099911474 -0.099911474 -0.099911474 + 25520 2.552 0.70695582 0.70695453 -4.9182641e-08 -0.099911735 -0.099911735 -0.099911735 + 25530 2.553 0.70695628 0.706955 -4.9932896e-08 -0.099911995 -0.099911995 -0.099911995 + 25540 2.554 0.70695673 0.70695546 -4.9825829e-08 -0.099912254 -0.099912254 -0.099912254 + 25550 2.555 0.70695718 0.70695592 -4.8866497e-08 -0.099912513 -0.099912513 -0.099912513 + 25560 2.556 0.70695764 0.70695638 -4.7079541e-08 -0.09991277 -0.09991277 -0.09991277 + 25570 2.557 0.70695809 0.70695684 -4.4508558e-08 -0.099913027 -0.099913027 -0.099913027 + 25580 2.558 0.70695854 0.7069573 -4.1215038e-08 -0.099913283 -0.099913283 -0.099913283 + 25590 2.559 0.70695899 0.70695775 -3.7276903e-08 -0.099913539 -0.099913539 -0.099913539 + 25600 2.56 0.70695943 0.7069582 -3.278666e-08 -0.099913793 -0.099913793 -0.099913793 + 25610 2.561 0.70695988 0.70695865 -2.7849232e-08 -0.099914047 -0.099914047 -0.099914047 + 25620 2.562 0.70696033 0.7069591 -2.2579507e-08 -0.0999143 -0.0999143 -0.0999143 + 25630 2.563 0.70696077 0.70695955 -1.7099665e-08 -0.099914552 -0.099914552 -0.099914552 + 25640 2.564 0.70696122 0.70695999 -1.1536349e-08 -0.099914804 -0.099914804 -0.099914804 + 25650 2.565 0.70696166 0.70696044 -6.0177391e-09 -0.099915055 -0.099915055 -0.099915055 + 25660 2.566 0.7069621 0.70696088 -6.7059702e-10 -0.099915305 -0.099915305 -0.099915305 + 25670 2.567 0.70696254 0.70696132 4.3826405e-09 -0.099915554 -0.099915554 -0.099915554 + 25680 2.568 0.70696299 0.70696175 9.026666e-09 -0.099915802 -0.099915802 -0.099915802 + 25690 2.569 0.70696343 0.70696219 1.3155931e-08 -0.09991605 -0.09991605 -0.09991605 + 25700 2.57 0.70696387 0.70696262 1.6677042e-08 -0.099916297 -0.099916297 -0.099916297 + 25710 2.571 0.70696431 0.70696305 1.9510875e-08 -0.099916543 -0.099916543 -0.099916543 + 25720 2.572 0.70696474 0.70696348 2.1594347e-08 -0.099916789 -0.099916789 -0.099916789 + 25730 2.573 0.70696518 0.70696391 2.2881822e-08 -0.099917033 -0.099917033 -0.099917033 + 25740 2.574 0.70696561 0.70696434 2.3346104e-08 -0.099917277 -0.099917277 -0.099917277 + 25750 2.575 0.70696605 0.70696477 2.297901e-08 -0.09991752 -0.09991752 -0.09991752 + 25760 2.576 0.70696648 0.70696519 2.1791499e-08 -0.099917763 -0.099917763 -0.099917763 + 25770 2.577 0.70696691 0.70696562 1.9813363e-08 -0.099918005 -0.099918005 -0.099918005 + 25780 2.578 0.70696734 0.70696604 1.7092482e-08 -0.099918246 -0.099918246 -0.099918246 + 25790 2.579 0.70696777 0.70696646 1.3693673e-08 -0.099918486 -0.099918486 -0.099918486 + 25800 2.58 0.7069682 0.70696688 9.6971429e-09 -0.099918726 -0.099918726 -0.099918726 + 25810 2.581 0.70696862 0.7069673 5.1966028e-09 -0.099918964 -0.099918964 -0.099918964 + 25820 2.582 0.70696904 0.70696772 2.9706868e-10 -0.099919203 -0.099919203 -0.099919203 + 25830 2.583 0.70696946 0.70696814 -4.8875861e-09 -0.09991944 -0.09991944 -0.09991944 + 25840 2.584 0.70696988 0.70696856 -1.0237277e-08 -0.099919677 -0.099919677 -0.099919677 + 25850 2.585 0.7069703 0.70696898 -1.5628487e-08 -0.099919913 -0.099919913 -0.099919913 + 25860 2.586 0.70697072 0.70696939 -2.093712e-08 -0.099920148 -0.099920148 -0.099920148 + 25870 2.587 0.70697113 0.70696981 -2.6041352e-08 -0.099920382 -0.099920382 -0.099920382 + 25880 2.588 0.70697154 0.70697022 -3.0824431e-08 -0.099920616 -0.099920616 -0.099920616 + 25890 2.589 0.70697195 0.70697064 -3.5177341e-08 -0.099920849 -0.099920849 -0.099920849 + 25900 2.59 0.70697236 0.70697105 -3.9001289e-08 -0.099921082 -0.099921082 -0.099921082 + 25910 2.591 0.70697277 0.70697146 -4.2209945e-08 -0.099921313 -0.099921313 -0.099921313 + 25920 2.592 0.70697317 0.70697188 -4.4731387e-08 -0.099921544 -0.099921544 -0.099921544 + 25930 2.593 0.70697357 0.70697229 -4.6509718e-08 -0.099921775 -0.099921775 -0.099921775 + 25940 2.594 0.70697398 0.7069727 -4.7506293e-08 -0.099922004 -0.099922004 -0.099922004 + 25950 2.595 0.70697438 0.7069731 -4.7700565e-08 -0.099922233 -0.099922233 -0.099922233 + 25960 2.596 0.70697478 0.70697351 -4.7090496e-08 -0.099922462 -0.099922462 -0.099922462 + 25970 2.597 0.70697518 0.70697392 -4.569255e-08 -0.099922689 -0.099922689 -0.099922689 + 25980 2.598 0.70697557 0.70697432 -4.3541262e-08 -0.099922916 -0.099922916 -0.099922916 + 25990 2.599 0.70697597 0.70697472 -4.0688383e-08 -0.099923142 -0.099923142 -0.099923142 + 26000 2.6 0.70697637 0.70697513 -3.7201641e-08 -0.099923367 -0.099923367 -0.099923367 + 26010 2.601 0.70697676 0.70697553 -3.3163136e-08 -0.099923592 -0.099923592 -0.099923592 + 26020 2.602 0.70697716 0.70697592 -2.8667406e-08 -0.099923816 -0.099923816 -0.099923816 + 26030 2.603 0.70697755 0.70697632 -2.3819219e-08 -0.09992404 -0.09992404 -0.09992404 + 26040 2.604 0.70697794 0.70697672 -1.873113e-08 -0.099924262 -0.099924262 -0.099924262 + 26050 2.605 0.70697833 0.70697711 -1.3520869e-08 -0.099924485 -0.099924485 -0.099924485 + 26060 2.606 0.70697873 0.7069775 -8.3086186e-09 -0.099924706 -0.099924706 -0.099924706 + 26070 2.607 0.70697912 0.70697789 -3.2142456e-09 -0.099924927 -0.099924927 -0.099924927 + 26080 2.608 0.70697951 0.70697828 1.6454587e-09 -0.099925147 -0.099925147 -0.099925147 + 26090 2.609 0.7069799 0.70697866 6.1594525e-09 -0.099925366 -0.099925366 -0.099925366 + 26100 2.61 0.70698029 0.70697905 1.022498e-08 -0.099925585 -0.099925585 -0.099925585 + 26110 2.611 0.70698067 0.70697943 1.374991e-08 -0.099925803 -0.099925803 -0.099925803 + 26120 2.612 0.70698106 0.70697981 1.665482e-08 -0.09992602 -0.09992602 -0.09992602 + 26130 2.613 0.70698145 0.70698019 1.8874789e-08 -0.099926237 -0.099926237 -0.099926237 + 26140 2.614 0.70698183 0.70698057 2.0360839e-08 -0.099926453 -0.099926453 -0.099926453 + 26150 2.615 0.70698222 0.70698095 2.1081022e-08 -0.099926668 -0.099926668 -0.099926668 + 26160 2.616 0.7069826 0.70698132 2.1021096e-08 -0.099926883 -0.099926883 -0.099926883 + 26170 2.617 0.70698298 0.7069817 2.0184801e-08 -0.099927097 -0.099927097 -0.099927097 + 26180 2.618 0.70698336 0.70698207 1.8593721e-08 -0.099927311 -0.099927311 -0.099927311 + 26190 2.619 0.70698374 0.70698245 1.6286729e-08 -0.099927524 -0.099927524 -0.099927524 + 26200 2.62 0.70698412 0.70698282 1.3319047e-08 -0.099927736 -0.099927736 -0.099927736 + 26210 2.621 0.7069845 0.70698319 9.7609198e-09 -0.099927947 -0.099927947 -0.099927947 + 26220 2.622 0.70698487 0.70698356 5.695959e-09 -0.099928158 -0.099928158 -0.099928158 + 26230 2.623 0.70698525 0.70698393 1.2191777e-09 -0.099928368 -0.099928368 -0.099928368 + 26240 2.624 0.70698562 0.7069843 -3.5652283e-09 -0.099928578 -0.099928578 -0.099928578 + 26250 2.625 0.70698599 0.70698467 -8.5463044e-09 -0.099928787 -0.099928787 -0.099928787 + 26260 2.626 0.70698636 0.70698504 -1.360891e-08 -0.099928995 -0.099928995 -0.099928995 + 26270 2.627 0.70698672 0.7069854 -1.8636377e-08 -0.099929203 -0.099929203 -0.099929203 + 26280 2.628 0.70698709 0.70698577 -2.3513199e-08 -0.09992941 -0.09992941 -0.09992941 + 26290 2.629 0.70698745 0.70698614 -2.8127686e-08 -0.099929617 -0.099929617 -0.099929617 + 26300 2.63 0.70698782 0.7069865 -3.2374515e-08 -0.099929823 -0.099929823 -0.099929823 + 26310 2.631 0.70698818 0.70698687 -3.615714e-08 -0.099930028 -0.099930028 -0.099930028 + 26320 2.632 0.70698854 0.70698723 -3.938998e-08 -0.099930232 -0.099930232 -0.099930232 + 26330 2.633 0.70698889 0.7069876 -4.2000359e-08 -0.099930436 -0.099930436 -0.099930436 + 26340 2.634 0.70698925 0.70698796 -4.3930131e-08 -0.09993064 -0.09993064 -0.09993064 + 26350 2.635 0.7069896 0.70698832 -4.5136983e-08 -0.099930842 -0.099930842 -0.099930842 + 26360 2.636 0.70698996 0.70698868 -4.5595349e-08 -0.099931044 -0.099931044 -0.099931044 + 26370 2.637 0.70699031 0.70698904 -4.5296959e-08 -0.099931246 -0.099931246 -0.099931246 + 26380 2.638 0.70699066 0.7069894 -4.4250965e-08 -0.099931447 -0.099931447 -0.099931447 + 26390 2.639 0.70699101 0.70698976 -4.2483687e-08 -0.099931647 -0.099931647 -0.099931647 + 26400 2.64 0.70699136 0.70699011 -4.0037951e-08 -0.099931847 -0.099931847 -0.099931847 + 26410 2.641 0.70699171 0.70699047 -3.6972056e-08 -0.099932046 -0.099932046 -0.099932046 + 26420 2.642 0.70699206 0.70699082 -3.3358386e-08 -0.099932244 -0.099932244 -0.099932244 + 26430 2.643 0.70699241 0.70699117 -2.9281703e-08 -0.099932442 -0.099932442 -0.099932442 + 26440 2.644 0.70699276 0.70699152 -2.4837158e-08 -0.099932639 -0.099932639 -0.099932639 + 26450 2.645 0.7069931 0.70699187 -2.0128076e-08 -0.099932836 -0.099932836 -0.099932836 + 26460 2.646 0.70699345 0.70699222 -1.5263551e-08 -0.099933032 -0.099933032 -0.099933032 + 26470 2.647 0.70699379 0.70699257 -1.0355922e-08 -0.099933228 -0.099933228 -0.099933228 + 26480 2.648 0.70699414 0.70699291 -5.5181785e-09 -0.099933423 -0.099933423 -0.099933423 + 26490 2.649 0.70699448 0.70699325 -8.6136106e-10 -0.099933617 -0.099933617 -0.099933617 + 26500 2.65 0.70699483 0.70699359 3.507987e-09 -0.099933811 -0.099933811 -0.099933811 + 26510 2.651 0.70699517 0.70699393 7.4902557e-09 -0.099934004 -0.099934004 -0.099934004 + 26520 2.652 0.70699551 0.70699427 1.0995039e-08 -0.099934196 -0.099934196 -0.099934196 + 26530 2.653 0.70699586 0.70699461 1.3943183e-08 -0.099934388 -0.099934388 -0.099934388 + 26540 2.654 0.7069962 0.70699494 1.6268578e-08 -0.099934579 -0.099934579 -0.099934579 + 26550 2.655 0.70699654 0.70699528 1.7919633e-08 -0.09993477 -0.09993477 -0.09993477 + 26560 2.656 0.70699688 0.70699561 1.8860422e-08 -0.09993496 -0.09993496 -0.09993496 + 26570 2.657 0.70699722 0.70699594 1.9071461e-08 -0.09993515 -0.09993515 -0.09993515 + 26580 2.658 0.70699755 0.70699627 1.8550109e-08 -0.099935339 -0.099935339 -0.099935339 + 26590 2.659 0.70699789 0.7069966 1.7310572e-08 -0.099935528 -0.099935528 -0.099935528 + 26600 2.66 0.70699823 0.70699693 1.5383533e-08 -0.099935716 -0.099935716 -0.099935716 + 26610 2.661 0.70699856 0.70699726 1.281539e-08 -0.099935903 -0.099935903 -0.099935903 + 26620 2.662 0.70699889 0.70699759 9.6671452e-09 -0.09993609 -0.09993609 -0.09993609 + 26630 2.663 0.70699922 0.70699791 6.0129553e-09 -0.099936276 -0.099936276 -0.099936276 + 26640 2.664 0.70699955 0.70699824 1.9383889e-09 -0.099936461 -0.099936461 -0.099936461 + 26650 2.665 0.70699988 0.70699857 -2.4615778e-09 -0.099936647 -0.099936647 -0.099936647 + 26660 2.666 0.70700021 0.70699889 -7.0847727e-09 -0.099936831 -0.099936831 -0.099936831 + 26670 2.667 0.70700054 0.70699922 -1.18242e-08 -0.099937015 -0.099937015 -0.099937015 + 26680 2.668 0.70700086 0.70699954 -1.6570514e-08 -0.099937198 -0.099937198 -0.099937198 + 26690 2.669 0.70700118 0.70699987 -2.1214544e-08 -0.099937381 -0.099937381 -0.099937381 + 26700 2.67 0.7070015 0.70700019 -2.5649799e-08 -0.099937564 -0.099937564 -0.099937564 + 26710 2.671 0.70700182 0.70700051 -2.9774915e-08 -0.099937745 -0.099937745 -0.099937745 + 26720 2.672 0.70700214 0.70700083 -3.3495964e-08 -0.099937926 -0.099937926 -0.099937926 + 26730 2.673 0.70700246 0.70700116 -3.6728598e-08 -0.099938107 -0.099938107 -0.099938107 + 26740 2.674 0.70700277 0.70700148 -3.9399956e-08 -0.099938287 -0.099938287 -0.099938287 + 26750 2.675 0.70700309 0.7070018 -4.1450304e-08 -0.099938467 -0.099938467 -0.099938467 + 26760 2.676 0.7070034 0.70700212 -4.2834371e-08 -0.099938646 -0.099938646 -0.099938646 + 26770 2.677 0.70700371 0.70700244 -4.3522347e-08 -0.099938824 -0.099938824 -0.099938824 + 26780 2.678 0.70700403 0.70700275 -4.3500519e-08 -0.099939002 -0.099939002 -0.099939002 + 26790 2.679 0.70700434 0.70700307 -4.2771539e-08 -0.099939179 -0.099939179 -0.099939179 + 26800 2.68 0.70700465 0.70700339 -4.1354316e-08 -0.099939356 -0.099939356 -0.099939356 + 26810 2.681 0.70700495 0.7070037 -3.9283528e-08 -0.099939533 -0.099939533 -0.099939533 + 26820 2.682 0.70700526 0.70700401 -3.6608776e-08 -0.099939708 -0.099939708 -0.099939708 + 26830 2.683 0.70700557 0.70700433 -3.3393404e-08 -0.099939884 -0.099939884 -0.099939884 + 26840 2.684 0.70700588 0.70700464 -2.9712994e-08 -0.099940058 -0.099940058 -0.099940058 + 26850 2.685 0.70700618 0.70700495 -2.5653597e-08 -0.099940232 -0.099940232 -0.099940232 + 26860 2.686 0.70700649 0.70700526 -2.1309716e-08 -0.099940406 -0.099940406 -0.099940406 + 26870 2.687 0.70700679 0.70700556 -1.6782111e-08 -0.099940579 -0.099940579 -0.099940579 + 26880 2.688 0.7070071 0.70700587 -1.2175464e-08 -0.099940752 -0.099940752 -0.099940752 + 26890 2.689 0.7070074 0.70700617 -7.5959545e-09 -0.099940924 -0.099940924 -0.099940924 + 26900 2.69 0.70700771 0.70700647 -3.1488182e-09 -0.099941095 -0.099941095 -0.099941095 + 26910 2.691 0.70700801 0.70700677 1.0640726e-09 -0.099941266 -0.099941266 -0.099941266 + 26920 2.692 0.70700831 0.70700707 4.9465414e-09 -0.099941437 -0.099941437 -0.099941437 + 26930 2.693 0.70700862 0.70700737 8.4103017e-09 -0.099941607 -0.099941607 -0.099941607 + 26940 2.694 0.70700892 0.70700767 1.1376964e-08 -0.099941776 -0.099941776 -0.099941776 + 26950 2.695 0.70700922 0.70700797 1.3779808e-08 -0.099941945 -0.099941945 -0.099941945 + 26960 2.696 0.70700952 0.70700826 1.5565283e-08 -0.099942114 -0.099942114 -0.099942114 + 26970 2.697 0.70700982 0.70700855 1.6694197e-08 -0.099942282 -0.099942282 -0.099942282 + 26980 2.698 0.70701012 0.70700885 1.7142578e-08 -0.099942449 -0.099942449 -0.099942449 + 26990 2.699 0.70701042 0.70700914 1.6902175e-08 -0.099942616 -0.099942616 -0.099942616 + 27000 2.7 0.70701072 0.70700943 1.5980604e-08 -0.099942783 -0.099942783 -0.099942783 + 27010 2.701 0.70701101 0.70700972 1.4401123e-08 -0.099942948 -0.099942948 -0.099942948 + 27020 2.702 0.70701131 0.70701001 1.220205e-08 -0.099943114 -0.099943114 -0.099943114 + 27030 2.703 0.7070116 0.7070103 9.435837e-09 -0.099943279 -0.099943279 -0.099943279 + 27040 2.704 0.7070119 0.70701059 6.1678181e-09 -0.099943443 -0.099943443 -0.099943443 + 27050 2.705 0.70701219 0.70701088 2.4746714e-09 -0.099943607 -0.099943607 -0.099943607 + 27060 2.706 0.70701248 0.70701116 -1.5573806e-09 -0.09994377 -0.09994377 -0.09994377 + 27070 2.707 0.70701277 0.70701145 -5.8345826e-09 -0.099943933 -0.099943933 -0.099943933 + 27080 2.708 0.70701305 0.70701174 -1.0257825e-08 -0.099944096 -0.099944096 -0.099944096 + 27090 2.709 0.70701334 0.70701202 -1.4724941e-08 -0.099944258 -0.099944258 -0.099944258 + 27100 2.71 0.70701363 0.70701231 -1.9133063e-08 -0.099944419 -0.099944419 -0.099944419 + 27110 2.711 0.70701391 0.7070126 -2.3380992e-08 -0.09994458 -0.09994458 -0.09994458 + 27120 2.712 0.70701419 0.70701288 -2.737152e-08 -0.099944741 -0.099944741 -0.099944741 + 27130 2.713 0.70701447 0.70701317 -3.1013653e-08 -0.099944901 -0.099944901 -0.099944901 + 27140 2.714 0.70701475 0.70701345 -3.4224685e-08 -0.09994506 -0.09994506 -0.09994506 + 27150 2.715 0.70701503 0.70701373 -3.6932076e-08 -0.099945219 -0.099945219 -0.099945219 + 27160 2.716 0.70701531 0.70701402 -3.9075088e-08 -0.099945378 -0.099945378 -0.099945378 + 27170 2.717 0.70701558 0.7070143 -4.0606144e-08 -0.099945536 -0.099945536 -0.099945536 + 27180 2.718 0.70701586 0.70701458 -4.149189e-08 -0.099945693 -0.099945693 -0.099945693 + 27190 2.719 0.70701613 0.70701486 -4.171391e-08 -0.09994585 -0.09994585 -0.09994585 + 27200 2.72 0.70701641 0.70701514 -4.1269108e-08 -0.099946007 -0.099946007 -0.099946007 + 27210 2.721 0.70701668 0.70701542 -4.0169737e-08 -0.099946163 -0.099946163 -0.099946163 + 27220 2.722 0.70701695 0.7070157 -3.8443063e-08 -0.099946319 -0.099946319 -0.099946319 + 27230 2.723 0.70701723 0.70701597 -3.6130697e-08 -0.099946474 -0.099946474 -0.099946474 + 27240 2.724 0.7070175 0.70701625 -3.3287594e-08 -0.099946629 -0.099946629 -0.099946629 + 27250 2.725 0.70701777 0.70701653 -2.998075e-08 -0.099946783 -0.099946783 -0.099946783 + 27260 2.726 0.70701804 0.7070168 -2.628762e-08 -0.099946937 -0.099946937 -0.099946937 + 27270 2.727 0.70701831 0.70701707 -2.2294312e-08 -0.09994709 -0.09994709 -0.09994709 + 27280 2.728 0.70701858 0.70701734 -1.8093574e-08 -0.099947243 -0.099947243 -0.099947243 + 27290 2.729 0.70701885 0.70701761 -1.3782643e-08 -0.099947395 -0.099947395 -0.099947395 + 27300 2.73 0.70701912 0.70701788 -9.4609994e-09 -0.099947547 -0.099947547 -0.099947547 + 27310 2.731 0.70701938 0.70701815 -5.2280646e-09 -0.099947699 -0.099947699 -0.099947699 + 27320 2.732 0.70701965 0.70701841 -1.1809204e-09 -0.09994785 -0.09994785 -0.09994785 + 27330 2.733 0.70701992 0.70701868 2.5879185e-09 -0.099948 -0.099948 -0.099948 + 27340 2.734 0.70702019 0.70701894 5.9926183e-09 -0.09994815 -0.09994815 -0.09994815 + 27350 2.735 0.70702045 0.7070192 8.9559802e-09 -0.0999483 -0.0999483 -0.0999483 + 27360 2.736 0.70702072 0.70701947 1.1411189e-08 -0.099948449 -0.099948449 -0.099948449 + 27370 2.737 0.70702099 0.70701973 1.3303318e-08 -0.099948598 -0.099948598 -0.099948598 + 27380 2.738 0.70702125 0.70701998 1.4590559e-08 -0.099948746 -0.099948746 -0.099948746 + 27390 2.739 0.70702151 0.70702024 1.524514e-08 -0.099948894 -0.099948894 -0.099948894 + 27400 2.74 0.70702178 0.7070205 1.5253923e-08 -0.099949041 -0.099949041 -0.099949041 + 27410 2.741 0.70702204 0.70702076 1.4618664e-08 -0.099949188 -0.099949188 -0.099949188 + 27420 2.742 0.7070223 0.70702101 1.3355924e-08 -0.099949335 -0.099949335 -0.099949335 + 27430 2.743 0.70702256 0.70702127 1.1496647e-08 -0.099949481 -0.099949481 -0.099949481 + 27440 2.744 0.70702282 0.70702152 9.0853996e-09 -0.099949626 -0.099949626 -0.099949626 + 27450 2.745 0.70702308 0.70702178 6.1793106e-09 -0.099949771 -0.099949771 -0.099949771 + 27460 2.746 0.70702334 0.70702203 2.8467151e-09 -0.099949916 -0.099949916 -0.099949916 + 27470 2.747 0.7070236 0.70702229 -8.3444954e-10 -0.09995006 -0.09995006 -0.09995006 + 27480 2.748 0.70702385 0.70702254 -4.7784655e-09 -0.099950204 -0.099950204 -0.099950204 + 27490 2.749 0.70702411 0.70702279 -8.8938295e-09 -0.099950348 -0.099950348 -0.099950348 + 27500 2.75 0.70702436 0.70702305 -1.3085375e-08 -0.099950491 -0.099950491 -0.099950491 + 27510 2.751 0.70702461 0.7070233 -1.7256471e-08 -0.099950633 -0.099950633 -0.099950633 + 27520 2.752 0.70702486 0.70702355 -2.131125e-08 -0.099950775 -0.099950775 -0.099950775 + 27530 2.753 0.70702511 0.7070238 -2.5156811e-08 -0.099950917 -0.099950917 -0.099950917 + 27540 2.754 0.70702536 0.70702405 -2.8705344e-08 -0.099951058 -0.099951058 -0.099951058 + 27550 2.755 0.70702561 0.7070243 -3.187614e-08 -0.099951199 -0.099951199 -0.099951199 + 27560 2.756 0.70702585 0.70702455 -3.4597417e-08 -0.099951339 -0.099951339 -0.099951339 + 27570 2.757 0.7070261 0.7070248 -3.6807954e-08 -0.099951479 -0.099951479 -0.099951479 + 27580 2.758 0.70702634 0.70702505 -3.8458458e-08 -0.099951619 -0.099951619 -0.099951619 + 27590 2.759 0.70702658 0.7070253 -3.9512667e-08 -0.099951758 -0.099951758 -0.099951758 + 27600 2.76 0.70702683 0.70702555 -3.9948144e-08 -0.099951897 -0.099951897 -0.099951897 + 27610 2.761 0.70702707 0.7070258 -3.9756748e-08 -0.099952035 -0.099952035 -0.099952035 + 27620 2.762 0.70702731 0.70702604 -3.8944781e-08 -0.099952173 -0.099952173 -0.099952173 + 27630 2.763 0.70702755 0.70702629 -3.7532797e-08 -0.09995231 -0.09995231 -0.09995231 + 27640 2.764 0.70702779 0.70702653 -3.5555091e-08 -0.099952447 -0.099952447 -0.099952447 + 27650 2.765 0.70702803 0.70702678 -3.3058861e-08 -0.099952584 -0.099952584 -0.099952584 + 27660 2.766 0.70702827 0.70702702 -3.010309e-08 -0.09995272 -0.09995272 -0.09995272 + 27670 2.767 0.7070285 0.70702726 -2.6757149e-08 -0.099952856 -0.099952856 -0.099952856 + 27680 2.768 0.70702874 0.7070275 -2.3099175e-08 -0.099952991 -0.099952991 -0.099952991 + 27690 2.769 0.70702898 0.70702774 -1.9214242e-08 -0.099953126 -0.099953126 -0.099953126 + 27700 2.77 0.70702922 0.70702798 -1.5192388e-08 -0.099953261 -0.099953261 -0.099953261 + 27710 2.771 0.70702946 0.70702822 -1.1126526e-08 -0.099953395 -0.099953395 -0.099953395 + 27720 2.772 0.70702969 0.70702845 -7.1102999e-09 -0.099953529 -0.099953529 -0.099953529 + 27730 2.773 0.70702993 0.70702869 -3.235929e-09 -0.099953662 -0.099953662 -0.099953662 + 27740 2.774 0.70703016 0.70702892 4.0791023e-10 -0.099953795 -0.099953795 -0.099953795 + 27750 2.775 0.7070304 0.70702916 3.7381119e-09 -0.099953927 -0.099953927 -0.099953927 + 27760 2.776 0.70703064 0.70702939 6.6790351e-09 -0.099954059 -0.099954059 -0.099954059 + 27770 2.777 0.70703087 0.70702962 9.1642213e-09 -0.099954191 -0.099954191 -0.099954191 + 27780 2.778 0.70703111 0.70702985 1.1137895e-08 -0.099954322 -0.099954322 -0.099954322 + 27790 2.779 0.70703134 0.70703008 1.2556213e-08 -0.099954453 -0.099954453 -0.099954453 + 27800 2.78 0.70703157 0.7070303 1.338824e-08 -0.099954584 -0.099954584 -0.099954584 + 27810 2.781 0.70703181 0.70703053 1.3616615e-08 -0.099954714 -0.099954714 -0.099954714 + 27820 2.782 0.70703204 0.70703076 1.3237917e-08 -0.099954844 -0.099954844 -0.099954844 + 27830 2.783 0.70703227 0.70703098 1.2262695e-08 -0.099954973 -0.099954973 -0.099954973 + 27840 2.784 0.7070325 0.70703121 1.0715186e-08 -0.099955102 -0.099955102 -0.099955102 + 27850 2.785 0.70703273 0.70703143 8.6327161e-09 -0.099955231 -0.099955231 -0.099955231 + 27860 2.786 0.70703296 0.70703166 6.0648015e-09 -0.099955359 -0.099955359 -0.099955359 + 27870 2.787 0.70703319 0.70703188 3.0719735e-09 -0.099955487 -0.099955487 -0.099955487 + 27880 2.788 0.70703341 0.70703211 -2.7564735e-10 -0.099955614 -0.099955614 -0.099955614 + 27890 2.789 0.70703364 0.70703233 -3.8999933e-09 -0.099955741 -0.099955741 -0.099955741 + 27900 2.79 0.70703386 0.70703255 -7.7168685e-09 -0.099955868 -0.099955868 -0.099955868 + 27910 2.791 0.70703409 0.70703278 -1.1637904e-08 -0.099955994 -0.099955994 -0.099955994 + 27920 2.792 0.70703431 0.707033 -1.5572604e-08 -0.09995612 -0.09995612 -0.09995612 + 27930 2.793 0.70703453 0.70703322 -1.9430432e-08 -0.099956245 -0.099956245 -0.099956245 + 27940 2.794 0.70703475 0.70703344 -2.3122893e-08 -0.09995637 -0.09995637 -0.09995637 + 27950 2.795 0.70703497 0.70703366 -2.6565565e-08 -0.099956495 -0.099956495 -0.099956495 + 27960 2.796 0.70703519 0.70703389 -2.9680026e-08 -0.099956619 -0.099956619 -0.099956619 + 27970 2.797 0.70703541 0.70703411 -3.2395641e-08 -0.099956743 -0.099956743 -0.099956743 + 27980 2.798 0.70703562 0.70703433 -3.465116e-08 -0.099956867 -0.099956867 -0.099956867 + 27990 2.799 0.70703584 0.70703455 -3.6396105e-08 -0.09995699 -0.09995699 -0.09995699 + 28000 2.8 0.70703605 0.70703477 -3.7591888e-08 -0.099957113 -0.099957113 -0.099957113 + 28010 2.801 0.70703627 0.70703499 -3.8212674e-08 -0.099957235 -0.099957235 -0.099957235 + 28020 2.802 0.70703648 0.70703521 -3.8245927e-08 -0.099957357 -0.099957357 -0.099957357 + 28030 2.803 0.70703669 0.70703542 -3.7692663e-08 -0.099957479 -0.099957479 -0.099957479 + 28040 2.804 0.7070369 0.70703564 -3.6567386e-08 -0.0999576 -0.0999576 -0.0999576 + 28050 2.805 0.70703711 0.70703586 -3.4897709e-08 -0.099957721 -0.099957721 -0.099957721 + 28060 2.806 0.70703733 0.70703607 -3.2723685e-08 -0.099957842 -0.099957842 -0.099957842 + 28070 2.807 0.70703754 0.70703629 -3.0096843e-08 -0.099957962 -0.099957962 -0.099957962 + 28080 2.808 0.70703775 0.7070365 -2.7078973e-08 -0.099958082 -0.099958082 -0.099958082 + 28090 2.809 0.70703796 0.70703671 -2.374067e-08 -0.099958202 -0.099958202 -0.099958202 + 28100 2.81 0.70703817 0.70703693 -2.0159683e-08 -0.099958321 -0.099958321 -0.099958321 + 28110 2.811 0.70703838 0.70703714 -1.641911e-08 -0.09995844 -0.09995844 -0.09995844 + 28120 2.812 0.70703858 0.70703735 -1.2605466e-08 -0.099958558 -0.099958558 -0.099958558 + 28130 2.813 0.70703879 0.70703755 -8.8066839e-09 -0.099958676 -0.099958676 -0.099958676 + 28140 2.814 0.707039 0.70703776 -5.1100898e-09 -0.099958794 -0.099958794 -0.099958794 + 28150 2.815 0.70703921 0.70703797 -1.6003939e-09 -0.099958911 -0.099958911 -0.099958911 + 28160 2.816 0.70703942 0.70703817 1.6422488e-09 -0.099959028 -0.099959028 -0.099959028 + 28170 2.817 0.70703963 0.70703838 4.5440682e-09 -0.099959145 -0.099959145 -0.099959145 + 28180 2.818 0.70703983 0.70703858 7.0393568e-09 -0.099959261 -0.099959261 -0.099959261 + 28190 2.819 0.70704004 0.70703878 9.071956e-09 -0.099959377 -0.099959377 -0.099959377 + 28200 2.82 0.70704025 0.70703899 1.0596519e-08 -0.099959493 -0.099959493 -0.099959493 + 28210 2.821 0.70704046 0.70703919 1.1579522e-08 -0.099959608 -0.099959608 -0.099959608 + 28220 2.822 0.70704066 0.70703939 1.1999998e-08 -0.099959723 -0.099959723 -0.099959723 + 28230 2.823 0.70704087 0.70703959 1.184998e-08 -0.099959837 -0.099959837 -0.099959837 + 28240 2.824 0.70704107 0.70703979 1.1134648e-08 -0.099959951 -0.099959951 -0.099959951 + 28250 2.825 0.70704127 0.70703999 9.8721685e-09 -0.099960065 -0.099960065 -0.099960065 + 28260 2.826 0.70704148 0.70704018 8.0932366e-09 -0.099960179 -0.099960179 -0.099960179 + 28270 2.827 0.70704168 0.70704038 5.8403326e-09 -0.099960292 -0.099960292 -0.099960292 + 28280 2.828 0.70704188 0.70704058 3.1667092e-09 -0.099960405 -0.099960405 -0.099960405 + 28290 2.829 0.70704208 0.70704078 1.3513454e-10 -0.099960517 -0.099960517 -0.099960517 + 28300 2.83 0.70704228 0.70704097 -3.183581e-09 -0.099960629 -0.099960629 -0.099960629 + 28310 2.831 0.70704248 0.70704117 -6.7122374e-09 -0.099960741 -0.099960741 -0.099960741 + 28320 2.832 0.70704268 0.70704137 -1.036904e-08 -0.099960853 -0.099960853 -0.099960853 + 28330 2.833 0.70704287 0.70704156 -1.4069495e-08 -0.099960964 -0.099960964 -0.099960964 + 28340 2.834 0.70704307 0.70704176 -1.7728359e-08 -0.099961074 -0.099961074 -0.099961074 + 28350 2.835 0.70704326 0.70704196 -2.1261607e-08 -0.099961185 -0.099961185 -0.099961185 + 28360 2.836 0.70704346 0.70704215 -2.4588354e-08 -0.099961295 -0.099961295 -0.099961295 + 28370 2.837 0.70704365 0.70704235 -2.7632713e-08 -0.099961405 -0.099961405 -0.099961405 + 28380 2.838 0.70704384 0.70704254 -3.0325519e-08 -0.099961514 -0.099961514 -0.099961514 + 28390 2.839 0.70704403 0.70704274 -3.2605904e-08 -0.099961623 -0.099961623 -0.099961623 + 28400 2.84 0.70704422 0.70704293 -3.442267e-08 -0.099961732 -0.099961732 -0.099961732 + 28410 2.841 0.70704441 0.70704313 -3.5735436e-08 -0.099961841 -0.099961841 -0.099961841 + 28420 2.842 0.7070446 0.70704332 -3.6515538e-08 -0.099961949 -0.099961949 -0.099961949 + 28430 2.843 0.70704479 0.70704351 -3.6746647e-08 -0.099962056 -0.099962056 -0.099962056 + 28440 2.844 0.70704498 0.70704371 -3.6425114e-08 -0.099962164 -0.099962164 -0.099962164 + 28450 2.845 0.70704516 0.7070439 -3.5560007e-08 -0.099962271 -0.099962271 -0.099962271 + 28460 2.846 0.70704535 0.70704409 -3.4172873e-08 -0.099962378 -0.099962378 -0.099962378 + 28470 2.847 0.70704553 0.70704428 -3.2297198e-08 -0.099962484 -0.099962484 -0.099962484 + 28480 2.848 0.70704572 0.70704447 -2.9977604e-08 -0.09996259 -0.09996259 -0.09996259 + 28490 2.849 0.70704591 0.70704466 -2.7268788e-08 -0.099962696 -0.099962696 -0.099962696 + 28500 2.85 0.70704609 0.70704485 -2.4234231e-08 -0.099962802 -0.099962802 -0.099962802 + 28510 2.851 0.70704628 0.70704503 -2.0944717e-08 -0.099962907 -0.099962907 -0.099962907 + 28520 2.852 0.70704646 0.70704522 -1.7476677e-08 -0.099963012 -0.099963012 -0.099963012 + 28530 2.853 0.70704665 0.7070454 -1.3910418e-08 -0.099963117 -0.099963117 -0.099963117 + 28540 2.854 0.70704683 0.70704559 -1.0328262e-08 -0.099963221 -0.099963221 -0.099963221 + 28550 2.855 0.70704701 0.70704577 -6.8126461e-09 -0.099963325 -0.099963325 -0.099963325 + 28560 2.856 0.7070472 0.70704595 -3.4442292e-09 -0.099963428 -0.099963428 -0.099963428 + 28570 2.857 0.70704738 0.70704614 -3.0003878e-10 -0.099963532 -0.099963532 -0.099963532 + 28580 2.858 0.70704757 0.70704632 2.5482883e-09 -0.099963635 -0.099963635 -0.099963635 + 28590 2.859 0.70704775 0.7070465 5.036137e-09 -0.099963737 -0.099963737 -0.099963737 + 28600 2.86 0.70704793 0.70704667 7.1073792e-09 -0.09996384 -0.09996384 -0.09996384 + 28610 2.861 0.70704811 0.70704685 8.715639e-09 -0.099963942 -0.099963942 -0.099963942 + 28620 2.862 0.7070483 0.70704703 9.8253296e-09 -0.099964043 -0.099964043 -0.099964043 + 28630 2.863 0.70704848 0.70704721 1.0412439e-08 -0.099964145 -0.099964145 -0.099964145 + 28640 2.864 0.70704866 0.70704738 1.0465049e-08 -0.099964246 -0.099964246 -0.099964246 + 28650 2.865 0.70704884 0.70704756 9.9835685e-09 -0.099964347 -0.099964347 -0.099964347 + 28660 2.866 0.70704902 0.70704773 8.9806913e-09 -0.099964447 -0.099964447 -0.099964447 + 28670 2.867 0.7070492 0.70704791 7.4810643e-09 -0.099964548 -0.099964548 -0.099964548 + 28680 2.868 0.70704938 0.70704808 5.5206852e-09 -0.099964647 -0.099964647 -0.099964647 + 28690 2.869 0.70704956 0.70704826 3.1460399e-09 -0.099964747 -0.099964747 -0.099964747 + 28700 2.87 0.70704973 0.70704843 4.1300166e-10 -0.099964846 -0.099964846 -0.099964846 + 28710 2.871 0.70704991 0.70704861 -2.6144825e-09 -0.099964945 -0.099964945 -0.099964945 + 28720 2.872 0.70705009 0.70704878 -5.8658871e-09 -0.099965044 -0.099965044 -0.099965044 + 28730 2.873 0.70705026 0.70704895 -9.2657502e-09 -0.099965142 -0.099965142 -0.099965142 + 28740 2.874 0.70705043 0.70704913 -1.2735424e-08 -0.099965241 -0.099965241 -0.099965241 + 28750 2.875 0.70705061 0.7070493 -1.6194893e-08 -0.099965338 -0.099965338 -0.099965338 + 28760 2.876 0.70705078 0.70704947 -1.956462e-08 -0.099965436 -0.099965436 -0.099965436 + 28770 2.877 0.70705095 0.70704964 -2.2767372e-08 -0.099965533 -0.099965533 -0.099965533 + 28780 2.878 0.70705112 0.70704982 -2.572999e-08 -0.09996563 -0.09996563 -0.09996563 + 28790 2.879 0.70705129 0.70704999 -2.8385063e-08 -0.099965727 -0.099965727 -0.099965727 + 28800 2.88 0.70705146 0.70705016 -3.0672454e-08 -0.099965823 -0.099965823 -0.099965823 + 28810 2.881 0.70705162 0.70705033 -3.2540668e-08 -0.099965919 -0.099965919 -0.099965919 + 28820 2.882 0.70705179 0.70705051 -3.3948006e-08 -0.099966015 -0.099966015 -0.099966015 + 28830 2.883 0.70705196 0.70705068 -3.4863495e-08 -0.09996611 -0.09996611 -0.09996611 + 28840 2.884 0.70705212 0.70705085 -3.5267571e-08 -0.099966205 -0.099966205 -0.099966205 + 28850 2.885 0.70705229 0.70705102 -3.515249e-08 -0.0999663 -0.0999663 -0.0999663 + 28860 2.886 0.70705245 0.70705119 -3.4522473e-08 -0.099966395 -0.099966395 -0.099966395 + 28870 2.887 0.70705262 0.70705136 -3.3393572e-08 -0.099966489 -0.099966489 -0.099966489 + 28880 2.888 0.70705278 0.70705152 -3.1793265e-08 -0.099966583 -0.099966583 -0.099966583 + 28890 2.889 0.70705295 0.70705169 -2.9759789e-08 -0.099966677 -0.099966677 -0.099966677 + 28900 2.89 0.70705311 0.70705186 -2.7341227e-08 -0.09996677 -0.09996677 -0.09996677 + 28910 2.891 0.70705327 0.70705202 -2.4594376e-08 -0.099966863 -0.099966863 -0.099966863 + 28920 2.892 0.70705344 0.70705219 -2.158341e-08 -0.099966956 -0.099966956 -0.099966956 + 28930 2.893 0.7070536 0.70705235 -1.8378384e-08 -0.099967049 -0.099967049 -0.099967049 + 28940 2.894 0.70705376 0.70705252 -1.5053602e-08 -0.099967141 -0.099967141 -0.099967141 + 28950 2.895 0.70705392 0.70705268 -1.1685901e-08 -0.099967233 -0.099967233 -0.099967233 + 28960 2.896 0.70705409 0.70705284 -8.3528678e-09 -0.099967325 -0.099967325 -0.099967325 + 28970 2.897 0.70705425 0.707053 -5.1310606e-09 -0.099967417 -0.099967417 -0.099967417 + 28980 2.898 0.70705441 0.70705316 -2.094245e-09 -0.099967508 -0.099967508 -0.099967508 + 28990 2.899 0.70705457 0.70705332 6.8829132e-10 -0.099967599 -0.099967599 -0.099967599 + 29000 2.9 0.70705474 0.70705348 3.1533193e-09 -0.099967689 -0.099967689 -0.099967689 + 29010 2.901 0.7070549 0.70705364 5.2451044e-09 -0.09996778 -0.09996778 -0.09996778 + 29020 2.902 0.70705506 0.7070538 6.916666e-09 -0.09996787 -0.09996787 -0.09996787 + 29030 2.903 0.70705522 0.70705395 8.1308311e-09 -0.09996796 -0.09996796 -0.09996796 + 29040 2.904 0.70705538 0.70705411 8.8610599e-09 -0.099968049 -0.099968049 -0.099968049 + 29050 2.905 0.70705554 0.70705427 9.0920237e-09 -0.099968139 -0.099968139 -0.099968139 + 29060 2.906 0.7070557 0.70705442 8.8199241e-09 -0.099968228 -0.099968228 -0.099968228 + 29070 2.907 0.70705586 0.70705458 8.0525445e-09 -0.099968316 -0.099968316 -0.099968316 + 29080 2.908 0.70705602 0.70705473 6.8090367e-09 -0.099968405 -0.099968405 -0.099968405 + 29090 2.909 0.70705618 0.70705488 5.1194459e-09 -0.099968493 -0.099968493 -0.099968493 + 29100 2.91 0.70705633 0.70705504 3.0239861e-09 -0.099968581 -0.099968581 -0.099968581 + 29110 2.911 0.70705649 0.70705519 5.720847e-10 -0.099968669 -0.099968669 -0.099968669 + 29120 2.912 0.70705665 0.70705534 -2.1787821e-09 -0.099968756 -0.099968756 -0.099968756 + 29130 2.913 0.7070568 0.7070555 -5.1644361e-09 -0.099968843 -0.099968843 -0.099968843 + 29140 2.914 0.70705695 0.70705565 -8.3154934e-09 -0.09996893 -0.09996893 -0.09996893 + 29150 2.915 0.70705711 0.7070558 -1.1558976e-08 -0.099969017 -0.099969017 -0.099969017 + 29160 2.916 0.70705726 0.70705596 -1.4820001e-08 -0.099969103 -0.099969103 -0.099969103 + 29170 2.917 0.70705741 0.70705611 -1.802351e-08 -0.099969189 -0.099969189 -0.099969189 + 29180 2.918 0.70705756 0.70705626 -2.1095993e-08 -0.099969275 -0.099969275 -0.099969275 + 29190 2.919 0.70705771 0.70705641 -2.396718e-08 -0.09996936 -0.09996936 -0.09996936 + 29200 2.92 0.70705786 0.70705657 -2.657164e-08 -0.099969446 -0.099969446 -0.099969446 + 29210 2.921 0.70705801 0.70705672 -2.8850278e-08 -0.099969531 -0.099969531 -0.099969531 + 29220 2.922 0.70705816 0.70705687 -3.0751671e-08 -0.099969616 -0.099969616 -0.099969616 + 29230 2.923 0.70705831 0.70705702 -3.223323e-08 -0.0999697 -0.0999697 -0.0999697 + 29240 2.924 0.70705845 0.70705717 -3.326215e-08 -0.099969784 -0.099969784 -0.099969784 + 29250 2.925 0.7070586 0.70705732 -3.3816138e-08 -0.099969868 -0.099969868 -0.099969868 + 29260 2.926 0.70705875 0.70705747 -3.3883892e-08 -0.099969952 -0.099969952 -0.099969952 + 29270 2.927 0.70705889 0.70705762 -3.3465328e-08 -0.099970036 -0.099970036 -0.099970036 + 29280 2.928 0.70705904 0.70705777 -3.2571548e-08 -0.099970119 -0.099970119 -0.099970119 + 29290 2.929 0.70705918 0.70705792 -3.1224549e-08 -0.099970202 -0.099970202 -0.099970202 + 29300 2.93 0.70705933 0.70705807 -2.945669e-08 -0.099970285 -0.099970285 -0.099970285 + 29310 2.931 0.70705947 0.70705822 -2.7309908e-08 -0.099970367 -0.099970367 -0.099970367 + 29320 2.932 0.70705961 0.70705836 -2.4834729e-08 -0.09997045 -0.09997045 -0.09997045 + 29330 2.933 0.70705976 0.70705851 -2.2089082e-08 -0.099970532 -0.099970532 -0.099970532 + 29340 2.934 0.7070599 0.70705866 -1.9136938e-08 -0.099970613 -0.099970613 -0.099970613 + 29350 2.935 0.70706005 0.7070588 -1.6046826e-08 -0.099970695 -0.099970695 -0.099970695 + 29360 2.936 0.70706019 0.70705894 -1.2890239e-08 -0.099970776 -0.099970776 -0.099970776 + 29370 2.937 0.70706033 0.70705909 -9.7399839e-09 -0.099970857 -0.099970857 -0.099970857 + 29380 2.938 0.70706048 0.70705923 -6.6685e-09 -0.099970938 -0.099970938 -0.099970938 + 29390 2.939 0.70706062 0.70705937 -3.7461955e-09 -0.099971018 -0.099971018 -0.099971018 + 29400 2.94 0.70706076 0.70705951 -1.039834e-09 -0.099971099 -0.099971099 -0.099971099 + 29410 2.941 0.7070609 0.70705965 1.3889902e-09 -0.099971179 -0.099971179 -0.099971179 + 29420 2.942 0.70706105 0.70705979 3.4852534e-09 -0.099971258 -0.099971258 -0.099971258 + 29430 2.943 0.70706119 0.70705993 5.2017475e-09 -0.099971338 -0.099971338 -0.099971338 + 29440 2.944 0.70706133 0.70706007 6.5001432e-09 -0.099971417 -0.099971417 -0.099971417 + 29450 2.945 0.70706147 0.70706021 7.3518435e-09 -0.099971496 -0.099971496 -0.099971496 + 29460 2.946 0.70706162 0.70706034 7.7386129e-09 -0.099971575 -0.099971575 -0.099971575 + 29470 2.947 0.70706176 0.70706048 7.652965e-09 -0.099971654 -0.099971654 -0.099971654 + 29480 2.948 0.7070619 0.70706062 7.0983021e-09 -0.099971732 -0.099971732 -0.099971732 + 29490 2.949 0.70706204 0.70706075 6.0888041e-09 -0.09997181 -0.09997181 -0.09997181 + 29500 2.95 0.70706218 0.70706089 4.6490695e-09 -0.099971888 -0.099971888 -0.099971888 + 29510 2.951 0.70706232 0.70706102 2.8135184e-09 -0.099971966 -0.099971966 -0.099971966 + 29520 2.952 0.70706245 0.70706116 6.2557025e-10 -0.099972043 -0.099972043 -0.099972043 + 29530 2.953 0.70706259 0.70706129 -1.8633811e-09 -0.09997212 -0.09997212 -0.09997212 + 29540 2.954 0.70706273 0.70706143 -4.5951746e-09 -0.099972197 -0.099972197 -0.099972197 + 29550 2.955 0.70706287 0.70706156 -7.5062397e-09 -0.099972274 -0.099972274 -0.099972274 + 29560 2.956 0.707063 0.7070617 -1.0529075e-08 -0.099972351 -0.099972351 -0.099972351 + 29570 2.957 0.70706314 0.70706183 -1.3593813e-08 -0.099972427 -0.099972427 -0.099972427 + 29580 2.958 0.70706327 0.70706197 -1.6629835e-08 -0.099972503 -0.099972503 -0.099972503 + 29590 2.959 0.7070634 0.7070621 -1.9567396e-08 -0.099972579 -0.099972579 -0.099972579 + 29600 2.96 0.70706354 0.70706224 -2.2339227e-08 -0.099972654 -0.099972654 -0.099972654 + 29610 2.961 0.70706367 0.70706237 -2.4882075e-08 -0.099972729 -0.099972729 -0.099972729 + 29620 2.962 0.7070638 0.70706251 -2.7138147e-08 -0.099972805 -0.099972805 -0.099972805 + 29630 2.963 0.70706393 0.70706264 -2.9056419e-08 -0.099972879 -0.099972879 -0.099972879 + 29640 2.964 0.70706406 0.70706277 -3.0593794e-08 -0.099972954 -0.099972954 -0.099972954 + 29650 2.965 0.70706419 0.70706291 -3.1716065e-08 -0.099973028 -0.099973028 -0.099973028 + 29660 2.966 0.70706432 0.70706304 -3.2398677e-08 -0.099973103 -0.099973103 -0.099973103 + 29670 2.967 0.70706445 0.70706317 -3.2627263e-08 -0.099973177 -0.099973177 -0.099973177 + 29680 2.968 0.70706458 0.7070633 -3.2397941e-08 -0.09997325 -0.09997325 -0.09997325 + 29690 2.969 0.7070647 0.70706344 -3.1717375e-08 -0.099973324 -0.099973324 -0.099973324 + 29700 2.97 0.70706483 0.70706357 -3.0602587e-08 -0.099973397 -0.099973397 -0.099973397 + 29710 2.971 0.70706496 0.7070637 -2.9080536e-08 -0.09997347 -0.09997347 -0.09997347 + 29720 2.972 0.70706509 0.70706383 -2.7187465e-08 -0.099973543 -0.099973543 -0.099973543 + 29730 2.973 0.70706521 0.70706396 -2.4968041e-08 -0.099973616 -0.099973616 -0.099973616 + 29740 2.974 0.70706534 0.70706409 -2.2474306e-08 -0.099973688 -0.099973688 -0.099973688 + 29750 2.975 0.70706547 0.70706422 -1.9764448e-08 -0.09997376 -0.09997376 -0.09997376 + 29760 2.976 0.70706559 0.70706435 -1.6901455e-08 -0.099973832 -0.099973832 -0.099973832 + 29770 2.977 0.70706572 0.70706447 -1.3951642e-08 -0.099973904 -0.099973904 -0.099973904 + 29780 2.978 0.70706585 0.7070646 -1.0983123e-08 -0.099973975 -0.099973975 -0.099973975 + 29790 2.979 0.70706597 0.70706472 -8.0642345e-09 -0.099974047 -0.099974047 -0.099974047 + 29800 2.98 0.7070661 0.70706485 -5.2619636e-09 -0.099974118 -0.099974118 -0.099974118 + 29810 2.981 0.70706623 0.70706497 -2.6404129e-09 -0.099974189 -0.099974189 -0.099974189 + 29820 2.982 0.70706635 0.7070651 -2.593337e-10 -0.099974259 -0.099974259 -0.099974259 + 29830 2.983 0.70706648 0.70706522 1.8272352e-09 -0.09997433 -0.09997433 -0.09997433 + 29840 2.984 0.7070666 0.70706534 3.5721929e-09 -0.0999744 -0.0999744 -0.0999744 + 29850 2.985 0.70706673 0.70706547 4.9364389e-09 -0.09997447 -0.09997447 -0.09997447 + 29860 2.986 0.70706685 0.70706559 5.889748e-09 -0.09997454 -0.09997454 -0.09997454 + 29870 2.987 0.70706698 0.70706571 6.4114388e-09 -0.09997461 -0.09997461 -0.09997461 + 29880 2.988 0.7070671 0.70706583 6.4908206e-09 -0.099974679 -0.099974679 -0.099974679 + 29890 2.989 0.70706723 0.70706595 6.1274086e-09 -0.099974748 -0.099974748 -0.099974748 + 29900 2.99 0.70706735 0.70706607 5.3309045e-09 -0.099974817 -0.099974817 -0.099974817 + 29910 2.991 0.70706748 0.70706619 4.120942e-09 -0.099974886 -0.099974886 -0.099974886 + 29920 2.992 0.7070676 0.70706631 2.5266059e-09 -0.099974954 -0.099974954 -0.099974954 + 29930 2.993 0.70706772 0.70706643 5.8573349e-10 -0.099975023 -0.099975023 -0.099975023 + 29940 2.994 0.70706784 0.70706655 -1.6559816e-09 -0.099975091 -0.099975091 -0.099975091 + 29950 2.995 0.70706796 0.70706666 -4.1460645e-09 -0.099975159 -0.099975159 -0.099975159 + 29960 2.996 0.70706808 0.70706678 -6.8264867e-09 -0.099975227 -0.099975227 -0.099975227 + 29970 2.997 0.7070682 0.7070669 -9.6350175e-09 -0.099975294 -0.099975294 -0.099975294 + 29980 2.998 0.70706832 0.70706702 -1.2506668e-08 -0.099975361 -0.099975361 -0.099975361 + 29990 2.999 0.70706844 0.70706714 -1.5375195e-08 -0.099975428 -0.099975428 -0.099975428 + 30000 3 0.70706856 0.70706726 -1.8174628e-08 -0.099975495 -0.099975495 -0.099975495 diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat new file mode 100644 index 0000000000..6150a7db80 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat @@ -0,0 +1,30000 @@ +0.0 0.5000379764466908 0.5000379762919002 6.84951750526408e-09 -1.5191124600081537e-05 +0.0001 0.5000759500598655 0.5000759496460607 1.3701761380005562e-08 -3.0382248537374107e-05 +0.0002 0.5001139208384794 0.5001139200613359 2.055593812527734e-08 -4.557337111074589e-05 +0.00030000000000000003 0.5001518887814818 0.500151887536587 2.741125297925362e-08 -6.076449161906539e-05 +0.0004 0.5001898538878166 0.5001898520706807 3.4266909972741066e-08 -7.595560936120119e-05 +0.0005 0.5002278161564215 0.5002278136624908 4.112211205234417e-08 -9.114672363602262e-05 +0.0006000000000000001 0.5002657755862286 0.5002657723108973 4.797606118628339e-08 -0.00010633783374239962 +0.0007000000000000001 0.5003037321761644 0.5003037280147862 5.482795840255905e-08 -0.00012152893897920281 +0.0008 0.5003416859251496 0.5003416807730506 6.167700394854592e-08 -0.00013672003864530422 +0.0009 0.5003796368320985 0.5003796305845891 6.852239733262655e-08 -0.00015191113203957588 +0.001 0.5004175848959201 0.5004175774483076 7.536333741786638e-08 -0.0001671022184608918 +0.0011 0.5004555301155172 0.5004555213631178 8.219902256773048e-08 -0.00018229329720812675 +0.0012000000000000001 0.500493472489787 0.500493462327938 8.90286507154725e-08 -0.0001974843675801575 +0.0013 0.5005314120176209 0.5005314003416931 9.585141939189024e-08 -0.00021267542887586175 +0.0014000000000000002 0.500569348697904 0.5005693354033143 1.0266652591267578e-07 -0.00022786648039411947 +0.0015 0.5006072825295161 0.5006072675117391 1.0947316744086555e-07 -0.00024305752143381193 +0.0016 0.5006452135113305 0.5006451966659119 1.1627054109786261e-07 -0.0002582485512938229 +0.0017000000000000001 0.5006831416422151 0.5006831228647828 1.230578439287422e-07 -0.0002734395692730374 +0.0018 0.5007210669210316 0.5007210461073092 1.2983427324919639e-07 -0.00028863057467034235 +0.0019000000000000002 0.5007589893466361 0.5007589663924545 1.365990265622674e-07 -0.0003038215667846303 +0.002 0.5007969089178788 0.5007968837191885 1.4335130162079768e-07 -0.00031901254491479084 +0.0021000000000000003 0.5008348256336034 0.500834798086488 1.5009029664947438e-07 -0.0003342035083597185 +0.0022 0.5008727394926485 0.5008727094933357 1.568152103170739e-07 -0.0003493944564183151 +0.0023000000000000004 0.5009106504938464 0.500910617938721 1.6352524197238427e-07 -0.0003645853883894761 +0.0024000000000000002 0.5009485586360234 0.5009485234216398 1.7021959164420508e-07 -0.0003797763035721096 +0.0025 0.5009864639180001 0.5009864259410943 1.7689746015236985e-07 -0.00039496720126511593 +0.0026 0.5010243663385908 0.5010243254960933 1.8355804921876828e-07 -0.00041015808076741087 +0.0027 0.501062265896605 0.5010622220856524 1.9020056146734632e-07 -0.0004253489413779052 +0.0028000000000000004 0.5011001625908451 0.501100115708793 1.9682420070166184e-07 -0.00044053978239551664 +0.0029000000000000002 0.5011380564201082 0.5011380063645434 2.0342817186325135e-07 -0.00045573060311916437 +0.003 0.5011759473831855 0.5011758940519381 2.100116811842856e-07 -0.000470921402847771 +0.0031 0.501213835478862 0.5012137787700183 2.1657393632634747e-07 -0.0004861121808802681 +0.0032 0.5012517207059172 0.5012516605178317 2.2311414626940973e-07 -0.0005013029365155867 +0.0033000000000000004 0.5012896030631242 0.501289539294432 2.2963152165877965e-07 -0.0005164936690526603 +0.0034000000000000002 0.5013274825492512 0.5013274150988798 2.361252747495879e-07 -0.000531684377790427 +0.0035 0.5013653591630596 0.5013652879302418 2.425946195316886e-07 -0.0005468750620278379 +0.0036 0.5014032329033056 0.5014031577875914 2.4903877196558177e-07 -0.0005620657210638397 +0.0037 0.5014411037687392 0.5014410246700081 2.5545694984363543e-07 -0.0005772563541973822 +0.0038000000000000004 0.5014789717581046 0.5014788885765783 2.6184837312315246e-07 -0.0005924469607274316 +0.0039000000000000003 0.5015168368701405 0.5015167495063941 2.6821226367657047e-07 -0.000607637539952946 +0.004 0.5015546991035795 0.5015546074585543 2.7454784581881775e-07 -0.0006228280911729001 +0.0041 0.5015925584571485 0.501592462432164 2.8085434605751303e-07 -0.0006380186136862546 +0.004200000000000001 0.5016304149295687 0.5016303144263348 2.87130993259499e-07 -0.000653209106791998 +0.0043 0.5016682685195559 0.5016681634401846 2.933770190116647e-07 -0.0006683995697891146 +0.0044 0.5017061192258192 0.5017060094728374 2.9959165737114546e-07 -0.0006835900019765903 +0.0045 0.5017439670470629 0.5017438525234236 3.0577414528165647e-07 -0.0006987804026534275 +0.004600000000000001 0.5017818119819851 0.5017816925910799 3.119237222126703e-07 -0.0007139707711186244 +0.0047 0.5018196540292785 0.5018195296749492 3.1803963071452834e-07 -0.0007291611066711835 +0.0048000000000000004 0.5018574931876301 0.5018573637741811 3.241211161686408e-07 -0.0007443514086101222 +0.004900000000000001 0.5018953294557208 0.5018951948879307 3.301674271760646e-07 -0.0007595416762344626 +0.005 0.5019331628322267 0.5019330230153597 3.361778155297479e-07 -0.0007747319088432236 +0.0051 0.5019709933158175 0.501970848155636 3.4215153615901883e-07 -0.0007899221057354466 +0.0052 0.502008820905158 0.5020086703079335 3.480878474904081e-07 -0.0008051122662101701 +0.005300000000000001 0.502046645598907 0.5020464894714324 3.539860113088711e-07 -0.0008203023895664214 +0.0054 0.5020844673957175 0.5020843056453191 3.5984529297983237e-07 -0.0008354924751032861 +0.0055 0.5021222862942378 0.5021221188287859 3.6566496142143023e-07 -0.0008506825221197972 +0.005600000000000001 0.5021601022931099 0.5021599290210311 3.7144428943758356e-07 -0.0008658725299150239 +0.0057 0.502197915390971 0.5021977362212594 3.771825536069695e-07 -0.0008810624977880571 +0.0058000000000000005 0.5022357255864521 0.5022355404286812 3.828790343940458e-07 -0.0008962524250379661 +0.005900000000000001 0.5022735328781794 0.5022733416425131 3.8853301617680636e-07 -0.0009114423109638337 +0.006 0.5023113372647737 0.5023111398619776 3.94143787718626e-07 -0.0009266321548647678 +0.0061 0.5023491387448502 0.5023489350863032 3.9971064150212676e-07 -0.0009418219560398622 +0.0062 0.5023869373170187 0.5023867273147241 4.052328746451117e-07 -0.0009570117137882334 +0.006300000000000001 0.502424732979884 0.5024245165464805 4.1070978862300933e-07 -0.0009722014274090086 +0.0064 0.5024625257320453 0.5024623027808185 4.1614068932438464e-07 -0.0009873910962013067 +0.0065 0.5025003155720967 0.5025000860169901 4.2152488693991685e-07 -0.0010025807194642606 +0.006600000000000001 0.5025381024986275 0.5025378662542531 4.268616965730221e-07 -0.0010177702964970226 +0.0067 0.5025758865102209 0.5025756434918709 4.321504380178087e-07 -0.0010329598265987477 +0.0068000000000000005 0.5026136676054558 0.5026134177291126 4.3739043584234416e-07 -0.0010481493090685968 +0.006900000000000001 0.5026514457829057 0.5026511889652533 4.4258101944416595e-07 -0.0010633387432057524 +0.007 0.502689221041139 0.5026889571995735 4.477215231335485e-07 -0.0010785281283093695 +0.0071 0.5027269933787187 0.5027267224313595 4.528112866886147e-07 -0.001093717463678645 +0.0072 0.5027647627942033 0.502764484659903 4.5784965455042403e-07 -0.0011089067486127868 +0.007300000000000001 0.5028025292861467 0.5028022438845013 4.628359765446177e-07 -0.0011240959824109999 +0.0074 0.5028402928530964 0.5028400001044574 4.677696081589744e-07 -0.0011392851643724834 +0.0075 0.5028780534935967 0.5028777533190797 4.72649909766254e-07 -0.0011544742937964925 +0.007600000000000001 0.5029158112061859 0.502915503527682 4.774762473735983e-07 -0.0011696633699822378 +0.0077 0.5029535659893982 0.5029532507295834 4.822479927613088e-07 -0.0011848523922289745 +0.0078000000000000005 0.5029913178417623 0.5029909949241087 4.86964523538358e-07 -0.0012000413598359683 +0.0079 0.5030290667618027 0.5030287361105875 4.916252225317663e-07 -0.0012152302721024468 +0.008 0.503066812748039 0.5030664742883553 4.9622947861927e-07 -0.0012304191283277256 +0.0081 0.5031045557989864 0.5031042094567524 5.007766866738095e-07 -0.001245607927811099 +0.0082 0.5031422959131552 0.5031419416151245 5.052662474525071e-07 -0.0012607966698518491 +0.0083 0.5031800330890511 0.5031796707628224 5.096975677076898e-07 -0.001275985353749265 +0.008400000000000001 0.5032177673251754 0.5032173968992021 5.140700606309778e-07 -0.0012911739788026679 +0.0085 0.503255498620025 0.5032551200236246 5.183831452981735e-07 -0.0013063625443114236 +0.0086 0.5032932269720921 0.5032928401354558 5.226362471688617e-07 -0.0013215510495748319 +0.008700000000000001 0.5033309523798648 0.503330557234067 5.268287981974318e-07 -0.0013367394938922585 +0.0088 0.5033686748418266 0.5033682713188341 5.309602367775668e-07 -0.0013519278765630528 +0.0089 0.5034063943564568 0.5034059823891377 5.35030007686732e-07 -0.0013671161968866197 +0.009 0.5034441109222307 0.5034436904443637 5.390375623637311e-07 -0.0013823044541623087 +0.0091 0.5034818245376188 0.5034813954839025 5.429823591307503e-07 -0.0013974926476895467 +0.009200000000000002 0.5035195352010882 0.5035190975071494 5.468638628602918e-07 -0.0014126807767677275 +0.009300000000000001 0.5035572429111012 0.5035567965135043 5.50681545197218e-07 -0.0014278688406962727 +0.0094 0.5035949476661163 0.5035944925023718 5.544348846142633e-07 -0.0014430568387746147 +0.0095 0.5036326494645884 0.5036321854731611 5.581233668561225e-07 -0.0014582447703021973 +0.009600000000000001 0.5036703483049679 0.503669875425286 5.617464846618958e-07 -0.0014734326345785089 +0.0097 0.5037080441857014 0.5037075623581647 5.653037375985548e-07 -0.0014886204309029428 +0.009800000000000001 0.503745737105232 0.50374524627122 5.687946325605431e-07 -0.0015038081585750486 +0.0099 0.5037834270619984 0.5037829271638787 5.722186838807986e-07 -0.001518995816894303 +0.01 0.503821114054436 0.5038206050355727 5.755754131087087e-07 -0.0015341834051602167 +0.010100000000000001 0.5038587980809763 0.5038582798857371 5.788643489545997e-07 -0.0015493709226723107 +0.0102 0.5038964791400475 0.5038959517138121 5.820850278448475e-07 -0.0015645583687300846 +0.0103 0.5039341572300742 0.5039336205192418 5.852369937553448e-07 -0.0015797457426331041 +0.0104 0.5039718323494766 0.5039712863014745 5.883197977674115e-07 -0.0015949330436809462 +0.0105 0.5040095044966726 0.5040089490599624 5.913329992890404e-07 -0.001610120271173199 +0.010600000000000002 0.5040471736700761 0.504046608794162 5.942761648891626e-07 -0.0016253074244094114 +0.010700000000000001 0.5040848398680976 0.5040842655035332 5.971488692968485e-07 -0.0016404945026891828 +0.0108 0.5041225030891443 0.5041219191875406 5.999506948461963e-07 -0.00165568150531214 +0.0109 0.5041601633316206 0.5041595698456518 6.026812319759323e-07 -0.0016708684315779267 +0.011 0.5041978205939273 0.5041972174773388 6.053400787853214e-07 -0.001686055280786153 +0.011100000000000002 0.5042354748744621 0.5042348620820769 6.079268418113237e-07 -0.0017012420522364959 +0.011200000000000002 0.5042731261716198 0.5042725036593453 6.104411350849048e-07 -0.0017164287452286376 +0.011300000000000001 0.5043107744837922 0.5043101422086269 6.128825813522809e-07 -0.0017316153590622553 +0.0114 0.504348419809368 0.5043477777294076 6.152508109091848e-07 -0.0017468018930370422 +0.0115 0.5043860621467331 0.5043854102211777 6.175454629886445e-07 -0.0017619883464527033 +0.011600000000000001 0.5044237014942708 0.50442303968343 6.197661845952496e-07 -0.0017771747186089704 +0.0117 0.5044613378503613 0.5044606661156613 6.219126316153734e-07 -0.0017923610088056265 +0.011800000000000001 0.5044989712133822 0.504498289517371 6.239844677069506e-07 -0.0018075472163423868 +0.0119 0.5045366015817084 0.5045359098880625 6.259813652431667e-07 -0.0018227333405190394 +0.012 0.5045742289537126 0.504573527227242 6.279030053679691e-07 -0.0018379193806353723 +0.012100000000000001 0.5046118533277648 0.5046111415344187 6.297490774409553e-07 -0.0018531053359911844 +0.0122 0.5046494747022323 0.504648752809105 6.315192797035074e-07 -0.0018682912058863245 +0.0123 0.5046870930754804 0.5046863610508161 6.332133188347022e-07 -0.001883476989620625 +0.0124 0.504724708445872 0.5047239662590703 6.348309100068228e-07 -0.001898662686493935 +0.0125 0.5047623208117675 0.5047615684333888 6.363717775514921e-07 -0.0019138482958060866 +0.012600000000000002 0.5047999301715257 0.5047991675732953 6.378356546266062e-07 -0.001929033816857012 +0.012700000000000001 0.5048375365235026 0.5048367636783166 6.392222830498007e-07 -0.0019442192489466216 +0.0128 0.5048751398660524 0.5048743567479816 6.405314133539619e-07 -0.0019594045913747583 +0.0129 0.5049127401975279 0.5049119467818225 6.417628054533608e-07 -0.0019745898434414435 +0.013 0.504950337516279 0.5049495337793731 6.429162275889411e-07 -0.001989775004446598 +0.013100000000000002 0.5049879318206546 0.5049871177401704 6.439914574385419e-07 -0.002004960073690171 +0.013200000000000002 0.5050255231090014 0.5050246986637534 6.449882816728092e-07 -0.002020145050472155 +0.013300000000000001 0.5050631113796643 0.5050622765496636 6.459064960107064e-07 -0.0020353299340925557 +0.0134 0.5051006966309872 0.5050998513974447 6.467459052195146e-07 -0.00205051472385141 +0.0135 0.5051382788613117 0.5051374232066421 6.475063234478995e-07 -0.0020656994190487166 +0.013600000000000001 0.5051758580689784 0.5051749919768044 6.481875737818221e-07 -0.0020808840189845803 +0.0137 0.5052134342523261 0.5052125577074809 6.487894884665835e-07 -0.002096068522958994 +0.013800000000000002 0.5052510074096925 0.5052501203982239 6.493119092954025e-07 -0.0021112529302721008 +0.013900000000000001 0.5052885775394143 0.5052876800485872 6.497546871098159e-07 -0.002126437240224016 +0.014 0.5053261446398263 0.505325236658126 6.501176822992782e-07 -0.0021416214521148727 +0.014100000000000001 0.5053637087092628 0.5053627902263977 6.504007644680954e-07 -0.002156805565244785 +0.0142 0.5054012697460566 0.5054003407529617 6.506038123799129e-07 -0.0021719895789139134 +0.0143 0.5054388277485398 0.5054378882373783 6.507267145683393e-07 -0.0021871734924224285 +0.0144 0.505476382715043 0.5054754326792098 6.507693689483673e-07 -0.002202357305070568 +0.0145 0.505513934643897 0.5055129740780198 6.507316825388187e-07 -0.002217541016158514 +0.014600000000000002 0.5055514835334309 0.5055505124333729 6.506135721284778e-07 -0.002232724624986493 +0.014700000000000001 0.5055890293819734 0.5055880477448359 6.504149641650692e-07 -0.0022479081308548142 +0.0148 0.5056265721878528 0.505625580011976 6.501357940336128e-07 -0.002263091533063655 +0.0149 0.5056641119493965 0.5056631092343621 6.497760072776693e-07 -0.0022782748309134126 +0.015 0.5057016486649315 0.505700635411564 6.493355589887173e-07 -0.0022934580237043757 +0.0151 0.5057391823327847 0.5057381585431525 6.488144130845086e-07 -0.00230864111073687 +0.015200000000000002 0.505776712951282 0.5057756786286993 6.482125440299136e-07 -0.0023238240913111942 +0.015300000000000001 0.5058142405187497 0.505813195667777 6.475299355046538e-07 -0.0023390069647277636 +0.0154 0.5058517650335135 0.5058507096599593 6.467665805698353e-07 -0.0023541897302869486 +0.0155 0.5058892864938994 0.50588822060482 6.459224822785714e-07 -0.002369372387289209 +0.015600000000000001 0.5059268048982329 0.505925728501934 6.449976531763824e-07 -0.0023845549350348886 +0.015700000000000002 0.5059643202448398 0.5059632333508768 6.439921156342621e-07 -0.00239973737282449 +0.0158 0.5060018325320459 0.5060007351512242 6.429059016821448e-07 -0.002414919699958501 +0.0159 0.5060393417581773 0.5060382339025525 6.417390528423716e-07 -0.0024301019157373983 +0.016 0.5060768479215603 0.5060757296044385 6.404916202962241e-07 -0.0024452840194616634 +0.0161 0.5061143510205215 0.5061132222564588 6.391636651614796e-07 -0.00246046601043185 +0.0162 0.506151851053388 0.5061507118581908 6.37755258214856e-07 -0.0024756478879484956 +0.016300000000000002 0.5061893480184874 0.5061881984092118 6.362664798365003e-07 -0.0024908296513122263 +0.0164 0.5062268419141474 0.506225681909099 6.346974202875444e-07 -0.0025060112998235686 +0.0165 0.5062643327386973 0.5062631623574296 6.330481795435716e-07 -0.002521192832783187 +0.0166 0.5063018204904663 0.5063006397537808 6.313188672391057e-07 -0.002536374249491702 +0.0167 0.5063393051677848 0.5063381140977299 6.295096023345437e-07 -0.002551555549249751 +0.016800000000000002 0.5063767867689837 0.5063755853888532 6.276205143374014e-07 -0.002566736731358016 +0.016900000000000002 0.5064142652923951 0.5064130536267273 6.256517419700458e-07 -0.0025819177951172338 +0.017 0.5064517407363522 0.5064505188109283 6.236034335027618e-07 -0.00259709873982813 +0.0171 0.5064892130991893 0.5064879809410316 6.214757474198862e-07 -0.002612279564791409 +0.0172 0.5065266823792414 0.5065254400166124 6.192688513650957e-07 -0.002627460269307869 +0.0173 0.5065641485748454 0.5065628960372449 6.169829230295854e-07 -0.002642640852678302 +0.017400000000000002 0.5066016116843389 0.5066003490025027 6.146181498190018e-07 -0.0026578213142034847 +0.0175 0.5066390717060617 0.5066377989119587 6.121747287979318e-07 -0.0026730016531842874 +0.0176 0.5066765286383542 0.5066752457651849 6.096528661347911e-07 -0.0026881818689215354 +0.0177 0.5067139824795589 0.5067126895617524 6.070527783785806e-07 -0.002703361960716133 +0.0178 0.5067514332280196 0.5067501303012312 6.043746915707082e-07 -0.0027185419278689784 +0.017900000000000003 0.5067888808820823 0.5067875679831904 6.016188412449885e-07 -0.002733721769680997 +0.018 0.5068263254400942 0.5068250026071978 5.987854725941766e-07 -0.0027489014854531757 +0.0181 0.5068637669004048 0.5068624341728196 5.958748404144565e-07 -0.0027640810744864134 +0.0182 0.5069012052613653 0.5068998626796217 5.92887208883397e-07 -0.00277926053608174 +0.0183 0.5069386405213288 0.5069372881271677 5.898228520040405e-07 -0.0027944398695401995 +0.018400000000000003 0.5069760726786507 0.5069747105150197 5.866820533828587e-07 -0.002809619074162806 +0.0185 0.5070135017316887 0.5070121298427388 5.834651058966855e-07 -0.002824798149250607 +0.018600000000000002 0.5070509276788023 0.5070495461098844 5.801723118592506e-07 -0.00283997709410474 +0.018699999999999998 0.5070883505183537 0.5070869593160139 5.768039835762906e-07 -0.002855155908026291 +0.0188 0.5071257702487071 0.5071243694606832 5.733604420687932e-07 -0.0028703345903164147 +0.018900000000000004 0.5071631868682294 0.507161776543446 5.698420183497532e-07 -0.002885513140276236 +0.019 0.5072006003752901 0.5071991805638548 5.662490522584385e-07 -0.0029006915572069637 +0.019100000000000002 0.5072380107682614 0.5072365815214595 5.625818939036797e-07 -0.0029158698404098183 +0.019200000000000002 0.5072754180455177 0.507273979415808 5.58840901887514e-07 -0.002931047989186042 +0.0193 0.5073128222054364 0.5073113742464463 5.550264443598962e-07 -0.0029462260028368993 +0.0194 0.507350223246398 0.5073487660129179 5.511388991297217e-07 -0.0029614038806636492 +0.0195 0.5073876211667858 0.5073861547147644 5.471786526101141e-07 -0.002976581621967617 +0.019600000000000003 0.5074250159649857 0.5074235403515248 5.431461009286487e-07 -0.0029917592260501336 +0.019700000000000002 0.507462407639387 0.5074609229227356 5.390416489836625e-07 -0.00300693669221257 +0.0198 0.5074997961883821 0.507498302427931 5.348657112214106e-07 -0.0030221140197563114 +0.0199 0.5075371816103665 0.5075356788666427 5.306187106368654e-07 -0.003037291207982773 +0.02 0.507574563903739 0.5075730522383992 5.263010799949619e-07 -0.0030524682561933695 +0.0201 0.5076119430669017 0.5076104225427269 5.219132604983301e-07 -0.003067645163689581 +0.020200000000000003 0.50764931909826 0.5076477897791493 5.174557025644511e-07 -0.003082821929772911 +0.020300000000000002 0.5076866919962233 0.5076851539471865 5.129288653815678e-07 -0.0030979985537448575 +0.0204 0.5077240617592041 0.5077225150463565 5.083332172972632e-07 -0.0031131750349069677 +0.0205 0.5077614283856187 0.5077598730761737 5.036692352633487e-07 -0.003128351372560806 +0.0206 0.5077987918738868 0.5077972280361495 4.989374049468864e-07 -0.00314352756600797 +0.020700000000000003 0.5078361522224323 0.5078345799257924 4.941382210632561e-07 -0.003158703614550085 +0.0208 0.5078735094296827 0.5078719287446075 4.89272186932066e-07 -0.0031738795174888093 +0.020900000000000002 0.5079108634940694 0.5079092744920969 4.843398143661304e-07 -0.0031890552741258016 +0.021 0.5079482144140282 0.5079466171677589 4.79341624115559e-07 -0.0032042308837627654 +0.0211 0.507985562187998 0.5079839567710882 4.7427814486855624e-07 -0.0032194063457014256 +0.021200000000000004 0.5080229068144227 0.5080212933015767 4.6914991452817745e-07 -0.003234581659243552 +0.0213 0.5080602482917502 0.5080586267587127 4.63957479046595e-07 -0.003249756823690919 +0.021400000000000002 0.5080975866184325 0.5080959571419802 4.587013929246986e-07 -0.00326493183834532 +0.0215 0.5081349217929261 0.50813328445086 4.533822187680059e-07 -0.0032801067025086286 +0.0216 0.5081722538136916 0.5081706086848292 4.4800052761972964e-07 -0.003295281415482701 +0.021700000000000004 0.5082095826791945 0.5082079298433609 4.425568985721995e-07 -0.003310455976569421 +0.0218 0.5082469083879042 0.5082452479259241 4.3705191918319564e-07 -0.003325630385070719 +0.021900000000000003 0.5082842309382953 0.508282562931984 4.314861849485929e-07 -0.003340804640288553 +0.022 0.508321550328847 0.5083198748610019 4.2586029935787195e-07 -0.0033559787415248818 +0.0221 0.5083588665580424 0.5083571837124348 4.201748738941191e-07 -0.0033711526880817163 +0.022200000000000004 0.5083961796243707 0.508394489485736 4.144305279230043e-07 -0.0033863264792610955 +0.0223 0.5084334895263249 0.5084317921803538 4.086278887760475e-07 -0.0034015001143650916 +0.022400000000000003 0.5084707962624037 0.5084690917957329 4.0276759152857444e-07 -0.003416673592695804 +0.0225 0.50850809983111 0.5085063883313132 3.9685027869440503e-07 -0.003431846913555331 +0.022600000000000002 0.5085454002309523 0.5085436817865306 3.90876600780965e-07 -0.0034470200762458355 +0.0227 0.5085826974604439 0.5085809721608162 3.848472157896854e-07 -0.003462193080069498 +0.0228 0.5086199915181039 0.5086182594535966 3.7876278916049166e-07 -0.003477365924328524 +0.022900000000000004 0.5086572824024558 0.5086555436642939 3.7262399385507017e-07 -0.0034925386083251605 +0.023 0.5086945701120286 0.5086928247923255 3.6643150994053464e-07 -0.003507711131361663 +0.023100000000000002 0.5087318546453569 0.5087301028371041 3.601860251167821e-07 -0.003522883492740339 +0.023200000000000002 0.5087691360009806 0.5087673777980374 3.538882341336258e-07 -0.003538055691763506 +0.0233 0.5088064141774452 0.5088046496745287 3.4753883879079517e-07 -0.0035532277277335353 +0.0234 0.5088436891733014 0.5088419184659759 3.4113854815998046e-07 -0.003568399599952793 +0.0235 0.5088809609871059 0.5088791841717727 3.3468807822401025e-07 -0.003583571307723729 +0.023600000000000003 0.508918229617421 0.5089164467913067 3.2818815190460704e-07 -0.0035987428503487713 +0.023700000000000002 0.5089554950628142 0.508953706323961 3.21639498812587e-07 -0.0036139142271303937 +0.0238 0.5089927573218593 0.5089909627691142 3.150428552756157e-07 -0.0036290854373711243 +0.0239 0.5090300163931358 0.5090282161261382 3.083989645880081e-07 -0.0036442564803734812 +0.024 0.509067272275229 0.5090654663944013 3.017085763445948e-07 -0.003659427355440047 +0.0241 0.50910452496673 0.5091027135732655 2.9497244682930024e-07 -0.0036745980618734173 +0.024200000000000003 0.509141774466236 0.5091399576620879 2.8819133870983116e-07 -0.0036897685989762327 +0.024300000000000002 0.5091790207723504 0.5091771986602195 2.8136602098216557e-07 -0.0037049389660511467 +0.0244 0.5092162638836829 0.5092144365670069 2.744972688595304e-07 -0.0037201091624008715 +0.0245 0.5092535037988484 0.5092516713817904 2.675858636058681e-07 -0.0037352791873281155 +0.0246 0.5092907405164687 0.5092889031039051 2.606325927856368e-07 -0.003750449040135641 +0.024700000000000003 0.5093279740351722 0.5093261317326803 2.5363825001400997e-07 -0.0037656187201262434 +0.0248 0.5093652043535926 0.5093633572674394 2.46603634485032e-07 -0.0037807882266027385 +0.024900000000000002 0.5094024314703709 0.5094005797075007 2.395295513879514e-07 -0.0037959575588679823 +0.025 0.5094396553841539 0.5094377990521767 2.32416811657421e-07 -0.003811126716224862 +0.0251 0.5094768760935952 0.5094750153007733 2.2526623191798656e-07 -0.003826295697976295 +0.025200000000000004 0.5095140935973547 0.5095122284525915 2.1807863409550876e-07 -0.0038414645034252253 +0.0253 0.5095513078940985 0.5095494385069257 2.1085484586125247e-07 -0.0038566331318746444 +0.025400000000000002 0.5095885189825001 0.5095866454630649 2.0359569996575289e-07 -0.00387180158262756 +0.0255 0.5096257268612391 0.5096238493202916 1.9630203476617147e-07 -0.0038869698549870244 +0.0256 0.5096629315290017 0.5096610500778824 1.8897469337975092e-07 -0.0039021379482561155 +0.025700000000000004 0.5097001329844811 0.5096982477351083 1.8161452421117108e-07 -0.003917305861737952 +0.0258 0.5097373312263773 0.5097354422912335 1.742223806611154e-07 -0.003932473594735679 +0.025900000000000003 0.5097745262533968 0.5097726337455162 1.6679912086259296e-07 -0.003947641146552474 +0.026 0.5098117180642531 0.5098098220972088 1.5934560784747198e-07 -0.003962808516491553 +0.0261 0.5098489066576667 0.509847007345557 1.5186270928280177e-07 -0.003977975703856162 +0.026200000000000005 0.5098860920323648 0.5098841894898002 1.443512974291794e-07 -0.003993142707949577 +0.0263 0.5099232741870819 0.5099213685291719 1.368122489603385e-07 -0.004008309528075119 +0.026400000000000003 0.5099604531205595 0.5099585444628988 1.2924644497702698e-07 -0.0040234761635361375 +0.0265 0.5099976288315455 0.5099957172902013 1.2165477086822918e-07 -0.0040386426136360095 +0.026600000000000002 0.5100348013187956 0.5100328870102935 1.1403811608912129e-07 -0.004053808877678154 +0.0267 0.5100719705810725 0.5100700536223829 1.0639737425821583e-07 -0.004068974954966024 +0.0268 0.5101091366171457 0.5101072171256704 9.873344297695041e-08 -0.004084140844803098 +0.026900000000000004 0.5101462994257925 0.5101443775193506 9.104722360764317e-08 -0.004099306546492903 +0.027 0.510183459005797 0.5101815348026113 8.333962135675943e-08 -0.004114472059338988 +0.027100000000000003 0.5102206153559505 0.5102186889746335 7.561154506674495e-08 -0.004129637382644944 +0.027200000000000002 0.510257768475052 0.5102558400345921 6.786390701479794e-08 -0.004144802515714394 +0.0273 0.5102949183619073 0.5102929879816549 6.009762303083033e-08 -0.004159967457850998 +0.0274 0.5103320650153302 0.5103301328149829 5.231361226848419e-08 -0.004175132208358449 +0.0275 0.5103692084341415 0.5103672745337305 4.451279703859834e-08 -0.00419029676654048 +0.027600000000000003 0.5104063486171689 0.5104044131370453 3.669610273981938e-08 -0.004205461131700849 +0.027700000000000002 0.5104434855632487 0.5104415486240684 2.886445787941838e-08 -0.00422062530314336 +0.027800000000000002 0.5104806192712241 0.5104786809939336 2.1018793781857337e-08 -0.0042357892801718495 +0.0279 0.5105177497399453 0.510515810245768 1.3160044574911378e-08 -0.004250953062090188 +0.028 0.5105548769682711 0.5105529363786919 5.289147037013109e-09 -0.004266116648202283 +0.0281 0.510592000955067 0.5105900593918188 -2.5929594998919114e-09 -0.004281280037812079 +0.028200000000000003 0.5106291216992064 0.5106271792842546 -1.0485333219734105e-08 -0.004296443230223556 +0.028300000000000002 0.5106662391995702 0.5106642960550993 -1.8387029999261673e-08 -0.00431160622474073 +0.0284 0.5107033534550472 0.5107014097034449 -2.62971034531434e-08 -0.004326769020667652 +0.0285 0.5107404644645338 0.5107385202283771 -3.421460514733965e-08 -0.004341931617308414 +0.0286 0.5107775722269335 0.5107756276289742 -4.213858461124542e-08 -0.004357094013967139 +0.028700000000000003 0.5108146767411582 0.5108127319043076 -5.006808949294811e-08 -0.004372256209947991 +0.0288 0.5108517780061274 0.510849833053442 -5.800216568239286e-08 -0.004387418204555171 +0.028900000000000002 0.5108888760207677 0.5108869310754341 -6.5939857405925e-08 -0.004402579997092914 +0.029 0.5109259707840144 0.5109240259693345 -7.388020735899642e-08 -0.004417741586865495 +0.0291 0.5109630622948097 0.5109611177341857 -8.182225680331001e-08 -0.0044329029731772236 +0.029200000000000004 0.5110001505521043 0.5109982063690236 -8.976504570559762e-08 -0.004448064155332447 +0.0293 0.5110372355548563 0.5110352918728773 -9.770761282348883e-08 -0.0044632251326355565 +0.029400000000000003 0.5110743173020315 0.5110723742447681 -1.0564899585729925e-07 -0.0044783859043909715 +0.0295 0.5111113957926039 0.5111094534837105 -1.1358823152549102e-07 -0.0044935464699031565 +0.0296 0.5111484710255548 0.5111465295887115 -1.215243557207979e-07 -0.004508706828476608 +0.029700000000000004 0.5111855429998741 0.5111836025587717 -1.2945640359696142e-07 -0.004523866979415867 +0.0298 0.5112226117145588 0.5112206723928834 -1.3738340971791718e-07 -0.004539026922025509 +0.029900000000000003 0.5112596771686144 0.5112577390900322 -1.4530440813065315e-07 -0.004554186655610147 +0.03 0.5112967393610537 0.5112948026491968 -1.532184324970487e-07 -0.004569346179474434 +0.030100000000000002 0.5113337982908978 0.511331863069348 -1.6112451631938862e-07 -0.004584505492923062 +0.0302 0.5113708539571754 0.5113689203494497 -1.6902169282934087e-07 -0.004599664595260761 +0.0303 0.5114079063589235 0.5114059744884589 -1.7690899534184013e-07 -0.004614823485792299 +0.030400000000000003 0.5114449554951865 0.5114430254853245 -1.8478545724120998e-07 -0.004629982163822486 +0.0305 0.5114820013650172 0.5114800733389891 -1.926501120852464e-07 -0.004645140628656167 +0.030600000000000002 0.5115190439674758 0.5115171180483874 -2.0050199381338452e-07 -0.00466029887959823 +0.0307 0.5115560833016309 0.5115541596124469 -2.0834013683690422e-07 -0.0046754569159535965 +0.0308 0.5115931193665587 0.5115911980300882 -2.1616357610831916e-07 -0.004690614737027235 +0.030900000000000004 0.5116301521613434 0.5116282333002243 -2.2397134728791013e-07 -0.004705772342124151 +0.031 0.5116671816850771 0.5116652654217612 -2.3176248686862522e-07 -0.004720929730549388 +0.031100000000000003 0.5117042079368596 0.5117022943935973 -2.395360322315909e-07 -0.004736086901608029 +0.031200000000000002 0.511741230915799 0.5117393202146239 -2.4729102188203456e-07 -0.004751243854605199 +0.0313 0.5117782506210112 0.5117763428837255 -2.5502649542152867e-07 -0.0047664005888460636 +0.031400000000000004 0.5118152670516196 0.5118133623997785 -2.627414937284023e-07 -0.004781557103635826 +0.0315 0.5118522802067563 0.5118503787616527 -2.704350591797855e-07 -0.0047967133982797314 +0.0316 0.5118892900855604 0.5118873919682108 -2.7810623563773174e-07 -0.0048118694720830635 +0.031700000000000006 0.5119262966871791 0.5119244020183075 -2.8575406861575114e-07 -0.0048270253243511505 +0.0318 0.5119633000107682 0.5119614089107911 -2.933776054314663e-07 -0.004842180954389359 +0.031900000000000005 0.5120003000554905 0.5119984126445024 -3.0097589522048995e-07 -0.0048573363615030994 +0.032 0.5120372968205169 0.5120354132182746 -3.085479891862253e-07 -0.0048724915449978165 +0.032100000000000004 0.5120742903050265 0.5120724106309344 -3.160929406414992e-07 -0.004887646504179004 +0.0322 0.5121112805082055 0.5121094048813009 -3.236098051057068e-07 -0.004902801238352194 +0.0323 0.5121482674292488 0.512146395968186 -3.3109764055461177e-07 -0.004917955746822954 +0.0324 0.5121852510673581 0.5121833838903946 -3.385555073509572e-07 -0.004933110028896895 +0.0325 0.5122222314217437 0.5122203686467246 -3.4598246859141035e-07 -0.004948264083879677 +0.032600000000000004 0.5122592084916235 0.5122573502359666 -3.533775899400293e-07 -0.004963417911077 +0.0327 0.5122961822762229 0.5122943286569042 -3.6073994000296317e-07 -0.0049785715097945965 +0.0328 0.5123331527747753 0.5123313039083135 -3.680685903006964e-07 -0.004993724879338253 +0.0329 0.5123701199865216 0.5123682759889643 -3.7536261535131565e-07 -0.005008878019013787 +0.033 0.5124070839107105 0.512405244897619 -3.826210930313323e-07 -0.00502403092812708 +0.033100000000000004 0.5124440445465985 0.5124422106330327 -3.8984310446465997e-07 -0.005039183605984024 +0.0332 0.5124810018934496 0.5124791731939543 -3.9702773418914816e-07 -0.005054336051890578 +0.0333 0.5125179559505355 0.5125161325791248 -4.0417407037862674e-07 -0.005069488265152739 +0.0334 0.5125549067171353 0.5125530887872786 -4.112812045931058e-07 -0.00508464024507653 +0.0335 0.5125918541925363 0.512590041817143 -4.1834823247266506e-07 -0.005099791990968038 +0.033600000000000005 0.5126287983760324 0.5126269916674392 -4.253742534876537e-07 -0.005114943502133391 +0.0337 0.5126657392669259 0.5126639383368803 -4.3235837104971253e-07 -0.005130094777878742 +0.033800000000000004 0.5127026768645262 0.5127008818241736 -4.3929969265055213e-07 -0.005145245817510306 +0.0339 0.5127396111681503 0.512737822128019 -4.461973301117528e-07 -0.005160396620334332 +0.034 0.5127765421771223 0.5127747592471099 -4.530503996402757e-07 -0.005175547185657123 +0.0341 0.5128134698907745 0.5128116931801328 -4.598580218562187e-07 -0.005190697512785009 +0.0342 0.5128503943084458 0.5128486239257672 -4.6661932204261625e-07 -0.00520584760102438 +0.034300000000000004 0.5128873154294828 0.5128855514826864 -4.7333342997890604e-07 -0.005220997449681653 +0.0344 0.5129242332532395 0.5129224758495569 -4.799994806348185e-07 -0.005236147058063307 +0.0345 0.5129611477790772 0.5129593970250383 -4.866166135042427e-07 -0.005251296425475858 +0.0346 0.5129980590063641 0.512996315007784 -4.931839732713605e-07 -0.0052664455512258625 +0.0347 0.5130349669344761 0.5130332297964404 -4.997007097273798e-07 -0.00528159443461993 +0.034800000000000005 0.5130718715627962 0.5130701413896478 -5.061659780758454e-07 -0.005296743074964705 +0.0349 0.5131087728907139 0.5131070497860398 -5.125789387383506e-07 -0.0053118914715668715 +0.035 0.5131456709176269 0.5131439549842436 -5.189387578541371e-07 -0.005327039623733182 +0.0351 0.5131825656429391 0.5131808569828797 -5.252446068082506e-07 -0.005342187530770418 +0.0352 0.5132194570660615 0.5132177557805628 -5.314956627311407e-07 -0.005357335191985383 +0.035300000000000005 0.5132563451864128 0.5132546513759009 -5.376911089149949e-07 -0.005372482606684984 +0.0354 0.5132932300034181 0.5132915437674955 -5.438301342863827e-07 -0.005387629774176114 +0.0355 0.5133301115165092 0.5133284329539426 -5.499119336560554e-07 -0.005402776693765755 +0.0356 0.5133669897251253 0.5133653189338313 -5.559357083850802e-07 -0.005417923364760907 +0.0357 0.5134038646287121 0.5134022017057447 -5.619006658852399e-07 -0.0054330697864686285 +0.035800000000000005 0.5134407362267221 0.5134390812682599 -5.678060196745438e-07 -0.005448215958196012 +0.0359 0.5134776045186147 0.5134759576199481 -5.73650989960095e-07 -0.005463361879250218 +0.036 0.5135144695038557 0.5135128307593739 -5.794348037491126e-07 -0.0054785075489384195 +0.0361 0.513551331181918 0.5135497006850968 -5.851566940717756e-07 -0.0054936529665678665 +0.0362 0.5135881895522804 0.5135865673956695 -5.908159012579794e-07 -0.005508798131445853 +0.036300000000000006 0.5136250446144288 0.5136234308896396 -5.964116721601798e-07 -0.005523943042879698 +0.0364 0.5136618963678555 0.5136602911655479 -6.01943260902793e-07 -0.005539087700176793 +0.0365 0.5136987448120591 0.5136971482219305 -6.074099285213741e-07 -0.005554232102644552 +0.0366 0.5137355899465446 0.5137340020573172 -6.128109430458828e-07 -0.005569376249590446 +0.0367 0.5137724317708233 0.5137708526702323 -6.181455800557956e-07 -0.005584520140322003 +0.036800000000000006 0.5138092702844133 0.5138077000591944 -6.234131222915273e-07 -0.005599663774146785 +0.036899999999999995 0.5138461054868378 0.5138445442227166 -6.28612860154032e-07 -0.005614807150372408 +0.037 0.5138829373776272 0.5138813851593065 -6.337440914827575e-07 -0.005629950268306522 +0.0371 0.5139197659563178 0.5139182228674661 -6.388061218887131e-07 -0.005645093127256845 +0.037200000000000004 0.5139565912224514 0.5139550573456926 -6.437982644769136e-07 -0.005660235726531121 +0.03730000000000001 0.5139934131755763 0.5139918885924766 -6.487198404570016e-07 -0.005675378065437159 +0.037399999999999996 0.5140302318152471 0.5140287166063047 -6.535701786436476e-07 -0.005690520143282807 +0.0375 0.5140670471410234 0.5140655413856579 -6.58348616233706e-07 -0.005705661959375974 +0.0376 0.514103859152471 0.514102362929012 -6.630544986396814e-07 -0.005720803513024614 +0.037700000000000004 0.5141406678491619 0.5141391812348377 -6.676871788791061e-07 -0.005735944803536702 +0.03780000000000001 0.5141774732306732 0.5141759963016006 -6.722460189623192e-07 -0.005751085830220288 +0.037899999999999996 0.5142142752965879 0.5142128081277614 -6.767303890042875e-07 -0.005766226592383467 +0.038 0.5142510740464945 0.5142496167117758 -6.811396672801173e-07 -0.005781367089334361 +0.0381 0.5142878694799873 0.5142864220520951 -6.854732413907882e-07 -0.0057965073203812 +0.038200000000000005 0.5143246615966652 0.5143232241471647 -6.897305069863968e-07 -0.0058116472848321835 +0.03830000000000001 0.5143614503961337 0.5143600229954269 -6.939108686543349e-07 -0.005826786981995614 +0.038400000000000004 0.5143982358780027 0.5143968185953178 -6.980137399192898e-07 -0.005841926411179849 +0.0385 0.5144350180418877 0.5144336109452702 -7.020385427436437e-07 -0.0058570655716932265 +0.0386 0.5144717968874094 0.5144704000437115 -7.059847088042304e-07 -0.005872204462844238 +0.038700000000000005 0.5145085724141933 0.5145071858890653 -7.098516781045561e-07 -0.005887343083941333 +0.0388 0.5145453446218702 0.51454396847975 -7.136389002515564e-07 -0.005902481434293023 +0.038900000000000004 0.5145821135100762 0.5145807478141806 -7.173458343445738e-07 -0.005917619513207928 +0.039 0.5146188790784518 0.5146175238907676 -7.209719482537125e-07 -0.005932757319994714 +0.0391 0.5146556413266427 0.5146542967079168 -7.245167193414837e-07 -0.005947894853962005 +0.039200000000000006 0.5146924002542986 0.5146910662640305 -7.279796347958722e-07 -0.005963032114418543 +0.0393 0.5147291558610751 0.5147278325575068 -7.313601909642031e-07 -0.005978169100673109 +0.039400000000000004 0.5147659081466315 0.5147645955867397 -7.346578938527415e-07 -0.005993305812034545 +0.0395 0.514802657110632 0.5148013553501195 -7.378722596262932e-07 -0.006008442247811741 +0.0396 0.5148394027527452 0.5148381118460328 -7.410028132759372e-07 -0.006023578407313624 +0.039700000000000006 0.5148761450726442 0.5148748650728623 -7.44049090672938e-07 -0.00603871428984919 +0.0398 0.5149128840700063 0.5149116150289872 -7.470106369589224e-07 -0.006053849894727487 +0.039900000000000005 0.5149496197445131 0.514948361712783 -7.498870073230357e-07 -0.006068985221257556 +0.04 0.5149863520958504 0.5149851051226219 -7.526777671684748e-07 -0.006084120268748611 +0.040100000000000004 0.515023081123708 0.5150218452568718 -7.553824919459551e-07 -0.006099255036509783 +0.0402 0.5150598068277796 0.5150585821138988 -7.58000767042688e-07 -0.006114389523850339 +0.0403 0.5150965292077633 0.5150953156920642 -7.605321885040262e-07 -0.006129523730079534 +0.040400000000000005 0.5151332482633607 0.5151320459897275 -7.629763624783514e-07 -0.006144657654506786 +0.0405 0.5151699639942774 0.5151687730052438 -7.653329051615643e-07 -0.0061597912964414196 +0.040600000000000004 0.5152066764002224 0.515205496736966 -7.676014439073064e-07 -0.0061749246551929095 +0.0407 0.5152433854809085 0.515242217183244 -7.697816156726489e-07 -0.006190057730070759 +0.0408 0.5152800912360521 0.5152789343424244 -7.71873068572404e-07 -0.006205190520384519 +0.040900000000000006 0.5153167936653731 0.5153156482128515 -7.738754611019694e-07 -0.006220323025443786 +0.041 0.5153534927685945 0.5153523587928666 -7.757884624148836e-07 -0.006235455244558247 +0.041100000000000005 0.5153901885454429 0.5153890660808083 -7.776117523228265e-07 -0.006250587177037548 +0.0412 0.515426880995648 0.5154257700750129 -7.793450215176634e-07 -0.006265718822191491 +0.0413 0.5154635701189425 0.5154624707738142 -7.809879712383783e-07 -0.006280850179329889 +0.041400000000000006 0.5155002559150624 0.5154991681755436 -7.82540313992719e-07 -0.006295981247762589 +0.0415 0.5155369383837465 0.5155358622785304 -7.840017729465742e-07 -0.006311112026799542 +0.0416 0.5155736175247366 0.5155725530811015 -7.853720823125521e-07 -0.006326242515750713 +0.0417 0.5156102933377773 0.5156092405815812 -7.86650987183446e-07 -0.006341372713926136 +0.041800000000000004 0.5156469658226155 0.5156459247782926 -7.878382435877462e-07 -0.006356502620635873 +0.04190000000000001 0.5156836349790015 0.5156826056695567 -7.889336189337293e-07 -0.006371632235190056 +0.042 0.5157203008066874 0.5157192832536921 -7.899368914543459e-07 -0.006386761556898896 +0.0421 0.5157569633054283 0.5157559575290163 -7.908478509843775e-07 -0.006401890585072623 +0.0422 0.5157936224749814 0.5157926284938446 -7.916662984608358e-07 -0.006417019319021561 +0.042300000000000004 0.5158302783151059 0.5158292961464908 -7.923920458119404e-07 -0.0064321477580559895 +0.04240000000000001 0.5158669308255635 0.5158659604852674 -7.930249162901859e-07 -0.006447275901486338 +0.0425 0.5159035800061184 0.5159026215084854 -7.935647447498972e-07 -0.006462403748623075 +0.0426 0.5159402258565362 0.5159392792144546 -7.940113769255852e-07 -0.006477531298776734 +0.0427 0.5159768683765845 0.5159759336014832 -7.943646705976803e-07 -0.006492658551257857 +0.042800000000000005 0.516013507566033 0.5160125846678785 -7.946244943712877e-07 -0.0065077855053770175 +0.04290000000000001 0.5160501434246532 0.5160492324119468 -7.947907287308986e-07 -0.006522912160444977 +0.043 0.5160867759522177 0.5160858768319931 -7.948632653742571e-07 -0.006538038515772432 +0.0431 0.5161234051485015 0.5161225179263218 -7.948420075454266e-07 -0.006553164570670178 +0.0432 0.5161600310132801 0.5161591556932363 -7.947268702013233e-07 -0.006568290324449006 +0.043300000000000005 0.5161966535463312 0.5161957901310394 -7.945177797341607e-07 -0.0065834157764198655 +0.04340000000000001 0.5162332727474335 0.5162324212380336 -7.942146739159384e-07 -0.0065985409258936594 +0.0435 0.5162698886163668 0.5162690490125204 -7.938175026755978e-07 -0.0066136657721814485 +0.0436 0.5163065011529124 0.516305673452801 -7.933262270443109e-07 -0.006628790314594252 +0.0437 0.5163431103568523 0.5163422945571763 -7.927408195995689e-07 -0.006643914552443203 +0.043800000000000006 0.5163797162279694 0.5163789123239471 -7.920612651868275e-07 -0.00665903848503947 +0.04390000000000001 0.5164163187660473 0.5164155267514137 -7.912875601423508e-07 -0.006674162111694266 +0.044 0.516452917970871 0.5164521378378766 -7.904197121821888e-07 -0.006689285431718911 +0.0441 0.5164895138422254 0.5164887455816364 -7.894577411238224e-07 -0.00670440844442472 +0.0442 0.5165261063798966 0.5165253499809936 -7.884016778314518e-07 -0.00671953114912311 +0.044300000000000006 0.5165626955836706 0.5165619510342493 -7.872515657703083e-07 -0.006734653545125541 +0.04440000000000001 0.5165992814533344 0.5165985487397041 -7.860074595633648e-07 -0.006749775631743483 +0.0445 0.5166358639886748 0.5166351430956598 -7.846694257684916e-07 -0.006764897408288573 +0.0446 0.5166724431894787 0.5166717341004183 -7.832375428229454e-07 -0.006780018874072364 +0.044700000000000004 0.5167090190555337 0.5167083217522822 -7.817119005437689e-07 -0.0067951400284065825 +0.044800000000000006 0.5167455915866268 0.5167449060495548 -7.800926009049469e-07 -0.006810260870602925 +0.0449 0.5167821607825454 0.5167814869905403 -7.783797574267837e-07 -0.006825381399973263 +0.045 0.5168187266430759 0.5168180645735432 -7.765734951203918e-07 -0.006840501615829376 +0.0451 0.5168552891680058 0.5168546387968698 -7.746739514313816e-07 -0.006855621517483229 +0.045200000000000004 0.5168918483571212 0.5168912096588267 -7.726812751851497e-07 -0.006870741104246742 +0.04530000000000001 0.5169284042102076 0.5169277771577221 -7.705956265313674e-07 -0.006885860375431929 +0.0454 0.5169649567270509 0.5169643412918653 -7.684171782207372e-07 -0.006900979330350937 +0.0455 0.5170015059074354 0.517000902059567 -7.661461141617032e-07 -0.006916097968315893 +0.0456 0.5170380517511453 0.5170374594591389 -7.637826304196516e-07 -0.006931216288638959 +0.045700000000000005 0.5170745942579638 0.5170740134888949 -7.613269342177098e-07 -0.006946334290632423 +0.04580000000000001 0.5171111334276728 0.5171105641471502 -7.587792446583919e-07 -0.006961451973608585 +0.0459 0.5171476692600538 0.5171471114322215 -7.561397927791091e-07 -0.0069765693368798514 +0.046 0.5171842017548869 0.5171836553424276 -7.534088211080814e-07 -0.006991686379758628 +0.0461 0.5172207309119508 0.5172201958760891 -7.505865842194481e-07 -0.00700680310155743 +0.046200000000000005 0.517257256731023 0.5172567330315285 -7.476733476230457e-07 -0.007021919501588748 +0.0463 0.5172937792118799 0.5172932668070707 -7.446693889856526e-07 -0.007037035579165224 +0.046400000000000004 0.5173302983542962 0.5173297972010422 -7.415749973538333e-07 -0.007052151333599561 +0.0465 0.517366814158045 0.5173663242117723 -7.383904734314939e-07 -0.007067266764204472 +0.0466 0.5174033266228979 0.5174028478375925 -7.351161294688602e-07 -0.007082381870292743 +0.046700000000000005 0.5174398357486245 0.5174393680768363 -7.317522890959438e-07 -0.00709749665117721 +0.0468 0.5174763415349927 0.5174758849278405 -7.282992879331651e-07 -0.007112611106170791 +0.046900000000000004 0.5175128439817686 0.5175123983889441 -7.247574723701078e-07 -0.007127725234586446 +0.047 0.5175493430887156 0.5175489084584892 -7.211272008977865e-07 -0.00714283903573722 +0.0471 0.5175858388555958 0.51758541513482 -7.174088429429126e-07 -0.007157952508936156 +0.047200000000000006 0.5176223312821686 0.5176219184162842 -7.136027797005617e-07 -0.007173065653496441 +0.0473 0.5176588203681916 0.5176584183012324 -7.097094034125284e-07 -0.007188178468731277 +0.047400000000000005 0.517695306113419 0.5176949147880181 -7.057291176448821e-07 -0.0072032909539539065 +0.0475 0.5177317885176034 0.5177314078749983 -7.016623374545006e-07 -0.007218403108477656 +0.0476 0.5177682675804948 0.517767897560533 -6.975094888894695e-07 -0.007233514931615942 +0.047700000000000006 0.51780474330184 0.5178043838429858 -6.932710095997052e-07 -0.007248626422682192 +0.0478 0.5178412156813834 0.5178408667207236 -6.889473478932651e-07 -0.0072637375809899325 +0.047900000000000005 0.5178776847188664 0.5178773461921169 -6.845389632914589e-07 -0.0072788484058527066 +0.048 0.5179141504140273 0.5179138222555397 -6.800463267508938e-07 -0.00729395889658418 +0.048100000000000004 0.5179506127666019 0.5179502949093701 -6.75469919941829e-07 -0.007309069052498019 +0.0482 0.5179870717763224 0.5179867641519894 -6.708102354147094e-07 -0.007324178872907994 +0.0483 0.5180235274429181 0.5180232299817836 -6.660677768777212e-07 -0.007339288357127888 +0.048400000000000006 0.5180599797661145 0.5180596923971422 -6.612430590302587e-07 -0.007354397504471644 +0.0485 0.5180964287456344 0.5180961513964587 -6.563366068967902e-07 -0.007369506314253139 +0.048600000000000004 0.5181328743811965 0.5181326069781311 -6.513489565485031e-07 -0.007384614785786398 +0.0487 0.5181693166725163 0.5181690591405613 -6.462806549367706e-07 -0.007399722918385476 +0.0488 0.5182057556193058 0.5182055078821561 -6.411322595045732e-07 -0.0074148307113645175 +0.048900000000000006 0.5182421912212727 0.518241953201326 -6.359043384085439e-07 -0.007429938164037692 +0.049 0.5182786234781211 0.5182783950964868 -6.305974701859007e-07 -0.0074450452757192425 +0.049100000000000005 0.5183150523895516 0.5183148335660581 -6.252122439209806e-07 -0.007460152045723501 +0.0492 0.51835147795526 0.5183512686084649 -6.19749259189728e-07 -0.00747525847336481 +0.049300000000000004 0.518387900174939 0.5183877002221364 -6.142091257821392e-07 -0.007490364557957619 +0.049400000000000006 0.5184243190482765 0.5184241284055072 -6.085924638132845e-07 -0.007505470298816436 +0.0495 0.5184607345749561 0.5184605531570166 -6.028999038343308e-07 -0.00752057569525581 +0.0496 0.5184971467546575 0.5184969744751088 -5.971320861108964e-07 -0.007535680746590379 +0.0497 0.5185335555870555 0.5185333923582333 -5.912896615667407e-07 -0.007550785452134829 +0.049800000000000004 0.5185699610718209 0.5185698068048447 -5.853732908955855e-07 -0.007565889811203905 +0.04990000000000001 0.5186063632086195 0.518606217813403 -5.793836445611156e-07 -0.007580993823112437 +0.05 0.5186427619971127 0.5186426253823735 -5.733214030745337e-07 -0.007596097487175288 +0.0501 0.5186791574369568 0.5186790295102267 -5.671872569390501e-07 -0.00761120080270741 +0.0502 0.518715549527804 0.518715430195439 -5.60981905817215e-07 -0.007626303769023799 +0.050300000000000004 0.5187519382693008 0.5187518274364924 -5.547060596411413e-07 -0.0076414063854395396 +0.05040000000000001 0.5187883236610888 0.5187882212318742 -5.483604377798379e-07 -0.007656508651269745 +0.0505 0.5188247057028053 0.5188246115800778 -5.419457686506313e-07 -0.007671610565829632 +0.0506 0.5188610843940817 0.5188609984796022 -5.354627906350995e-07 -0.007686712128434459 +0.0507 0.5188974597345446 0.5188973819289525 -5.289122512464051e-07 -0.007701813338399546 +0.050800000000000005 0.5189338317238148 0.51893376192664 -5.222949072125616e-07 -0.007716914195040301 +0.05090000000000001 0.5189702003615084 0.5189701384711815 -5.156115243099002e-07 -0.007732014697672163 +0.051 0.5190065656472356 0.5190065115611003 -5.088628776128701e-07 -0.007747114845610664 +0.0511 0.519042927580601 0.519042881194926 -5.020497510777044e-07 -0.007762214638171378 +0.0512 0.519079286161204 0.5190792473711944 -4.951729375701763e-07 -0.007777314074669964 +0.051300000000000005 0.5191156413886381 0.5191156100884478 -4.882332389211097e-07 -0.007792413154422137 +0.05140000000000001 0.519151993262491 0.5191519693452346 -4.812314654822902e-07 -0.0078075118767436755 +0.0515 0.5191883417823449 0.5191883251401098 -4.7416843632075434e-07 -0.007822610240950425 +0.0516 0.5192246869477756 0.5192246774716354 -4.67044978968989e-07 -0.007837708246358306 +0.0517 0.5192610287583532 0.5192610263383796 -4.5986192945268733e-07 -0.007852805892283274 +0.051800000000000006 0.5192973672136421 0.5192973717389175 -4.526201321519707e-07 -0.007867903178041397 +0.05190000000000001 0.5193337023132 0.5193337136718315 -4.4532043985689995e-07 -0.007883000102948774 +0.052 0.519370034056579 0.5193700521357096 -4.379637132123637e-07 -0.007898096666321587 +0.0521 0.5194063624433245 0.5194063871291482 -4.305508210511455e-07 -0.007913192867476071 +0.0522 0.5194426874729756 0.5194427186507495 -4.230826401996346e-07 -0.007928288705728535 +0.052300000000000006 0.5194790091450654 0.5194790466991239 -4.1556005525578144e-07 -0.007943384180395347 +0.05240000000000001 0.5195153274591203 0.5195153712728879 -4.0798395867236437e-07 -0.007958479290792948 +0.0525 0.5195516424146606 0.5195516923706659 -4.003552504794339e-07 -0.007973574036237868 +0.0526 0.5195879540111991 0.5195880099910892 -3.926748382843126e-07 -0.007988668416046655 +0.052700000000000004 0.519624262248243 0.5196243241327968 -3.849436370217951e-07 -0.008003762429535953 +0.05280000000000001 0.5196605671252923 0.5196606347944347 -3.7716256912068147e-07 -0.008018856076022478 +0.0529 0.5196968686418402 0.5196969419746564 -3.693325641984657e-07 -0.008033949354823003 +0.053 0.5197331667973734 0.5197332456721234 -3.6145455883929145e-07 -0.008049042265254368 +0.0531 0.5197694615913715 0.5197695458855043 -3.53529496704974e-07 -0.008064134806633483 +0.053200000000000004 0.519805753023307 0.5198058426134751 -3.4555832845173384e-07 -0.008079226978277319 +0.05330000000000001 0.5198420410926458 0.5198421358547204 -3.375420113416183e-07 -0.008094318779502934 +0.0534 0.5198783257988465 0.5198784256079318 -3.294815095478132e-07 -0.008109410209627433 +0.0535 0.5199146071413606 0.5199147118718092 -3.213777934607531e-07 -0.008124501267967993 +0.0536 0.5199508851196324 0.5199509946450596 -3.1323184024323325e-07 -0.008139591953841853 +0.053700000000000005 0.5199871597330991 0.5199872739263991 -3.050446330810086e-07 -0.008154682266566347 +0.05380000000000001 0.5200234309811903 0.5200235497145508 -2.968171616685167e-07 -0.008169772205458848 +0.0539 0.5200596988633291 0.5200598220082463 -2.8855042147335475e-07 -0.008184861769836812 +0.054 0.5200959633789303 0.520096090806225 -2.8024541408322445e-07 -0.008199950959017757 +0.0541 0.5201322245274016 0.5201323561072349 -2.7190314702552065e-07 -0.00821503977231928 +0.054200000000000005 0.5201684823081435 0.5201686179100317 -2.6352463335099774e-07 -0.008230128209059034 +0.0543 0.5202047367205488 0.5202048762133795 -2.551108919113254e-07 -0.008245216268554746 +0.054400000000000004 0.5202409877640022 0.5202411310160509 -2.466629468456105e-07 -0.00826030395012421 +0.0545 0.5202772354378814 0.5202773823168267 -2.3818182787183062e-07 -0.0082753912530853 +0.0546 0.5203134797415562 0.5203136301144958 -2.2966856973172245e-07 -0.008290478176755937 +0.054700000000000006 0.5203497206743887 0.5203498744078562 -2.2112421237119317e-07 -0.008305564720454134 +0.0548 0.5203859582357332 0.5203861151957135 -2.1254980074603136e-07 -0.00832065088349796 +0.054900000000000004 0.5204221924249361 0.5204223524768827 -2.039463846831291e-07 -0.008335736665205557 +0.055 0.5204584232413366 0.5204585862501868 -1.953150186306818e-07 -0.008350822064895139 +0.0551 0.5204946506842649 0.5204948165144576 -1.866567616998216e-07 -0.008365907081884989 +0.055200000000000006 0.520530874753044 0.5205310432685355 -1.7797267753971724e-07 -0.008380991715493454 +0.0553 0.5205670954469888 0.5205672665112697 -1.6926383403226275e-07 -0.008396075965038954 +0.055400000000000005 0.5206033127654061 0.5206034862415182 -1.6053130327819964e-07 -0.008411159829839993 +0.0555 0.5206395267075947 0.5206397024581471 -1.5177616158323914e-07 -0.008426243309215124 +0.055600000000000004 0.5206757372728454 0.5206759151600321 -1.4299948906948412e-07 -0.00844132640248298 +0.0557 0.5207119444604407 0.5207121243460575 -1.3420236975175692e-07 -0.008456409108962266 +0.0558 0.5207481482696548 0.5207483300151163 -1.25385891301677e-07 -0.008471491427971755 +0.055900000000000005 0.520784348699754 0.5207845321661105 -1.1655114495745522e-07 -0.00848657335883029 +0.056 0.5208205457499963 0.5208207307979513 -1.0769922533654386e-07 -0.00850165490085679 +0.056100000000000004 0.5208567394196313 0.5208569259095586 -9.883123038012531e-08 -0.00851673605337024 +0.0562 0.5208929297079005 0.520893117499861 -8.994826112412868e-08 -0.008531816815689692 +0.0563 0.5209291166140372 0.5209293055677969 -8.105142169229085e-08 -0.008546897187134283 +0.056400000000000006 0.5209653001372658 0.5209654901123133 -7.214181904288686e-08 -0.008561977167023211 +0.0565 0.5210014802768028 0.5210016711323662 -6.322056285076871e-08 -0.008577056754675743 +0.056600000000000004 0.5210376570318562 0.5210378486269208 -5.4288765410220874e-08 -0.008592135949411226 +0.0567 0.5210738304016255 0.5210740225949518 -4.5347541461487895e-08 -0.008607214750549074 +0.0568 0.521110000385302 0.5211101930354425 -3.639800807281324e-08 -0.00862229315740878 +0.056900000000000006 0.521146166982068 0.5211463599473857 -2.744128451206973e-08 -0.008637371169309894 +0.057 0.5211823301910976 0.5211825233297837 -1.8478492070685137e-08 -0.00865244878557205 +0.0571 0.5212184900115565 0.5212186831816472 -9.510753944813599e-09 -0.00866752600551495 +0.0572 0.521254646442602 0.521254839501997 -5.391950961240732e-10 -0.008682602828458374 +0.057300000000000004 0.5212907994833821 0.5212909922898626 8.435057891748032e-09 -0.008697679253722166 +0.05740000000000001 0.521326949133037 0.5213271415442834 1.7410876957182908e-08 -0.008712755280626249 +0.0575 0.5213630953906981 0.5213632872643075 2.638713269415005e-08 -0.008727830908490615 +0.0576 0.5213992382554877 0.5213994294489928 3.536269451570595e-08 -0.008742906136635328 +0.0577 0.5214353777265203 0.5214355680974058 4.433643076284799e-08 -0.00875798096438053 +0.057800000000000004 0.5214715138029011 0.5214717032086235 5.330720887278262e-08 -0.008773055391046431 +0.05790000000000001 0.521507646483727 0.521507834781731 6.227389552290741e-08 -0.008788129415953317 +0.058 0.5215437757680862 0.5215439628158237 7.12353567383639e-08 -0.008803203038421546 +0.0581 0.5215799016550581 0.5215800873100063 8.019045811408221e-08 -0.008818276257771549 +0.0582 0.5216160241437134 0.5216162082633921 8.913806484600606e-08 -0.008833349073323834 +0.058300000000000005 0.5216521432331144 0.5216523256751051 9.807704198783185e-08 -0.008848421484398981 +0.05840000000000001 0.5216882589223145 0.5216884395442773 1.0700625450998924e-07 -0.008863493490317642 +0.0585 0.5217243712103582 0.5217245498700515 1.1592456745229685e-07 -0.008878565090400543 +0.0586 0.5217604800962818 0.5217606566515784 1.248308461460068e-07 -0.008893636283968482 +0.0587 0.5217965855791126 0.5217967598880197 1.3372395631094935e-07 -0.008908707070342338 +0.058800000000000005 0.5218326876578692 0.5218328595785453 1.4260276415961615e-07 -0.008923777448843062 +0.05890000000000001 0.5218687863315613 0.521868955722335 1.5146613657757158e-07 -0.008938847418791676 +0.059 0.5219048815991905 0.5219050483185782 1.6031294133855845e-07 -0.008953916979509277 +0.0591 0.5219409734597491 0.5219411373664734 1.6914204711837577e-07 -0.008968986130317038 +0.0592 0.5219770619122208 0.5219772228652289 1.7795232366835112e-07 -0.008984054870536213 +0.059300000000000005 0.5220131469555809 0.5220133048140618 1.8674264204432411e-07 -0.008999123199488111 +0.05940000000000001 0.5220492285887957 0.5220493832121993 1.9551187466215758e-07 -0.009014191116494144 +0.0595 0.522085306810823 0.5220854580588774 2.0425889553365995e-07 -0.009029258620875778 +0.0596 0.522121381620612 0.5221215293533419 2.1298258033597417e-07 -0.00904432571195456 +0.0597 0.5221574530171027 0.5221575970948478 2.21681806591989e-07 -0.009059392389052115 +0.059800000000000006 0.5221935209992273 0.5221936612826596 2.3035545379523903e-07 -0.009074458651490145 +0.05990000000000001 0.5222295855659087 0.5222297219160511 2.3900240350704927e-07 -0.009089524498590419 +0.06 0.5222656467160613 0.5222657789943054 2.47621539689602e-07 -0.00910458992967479 +0.0601 0.522301704448591 0.5223018325167151 2.562117485810367e-07 -0.009119654944065182 +0.060200000000000004 0.5223377587623951 0.5223378824825822 2.6477191912566145e-07 -0.009134719541083606 +0.060300000000000006 0.522373809656362 0.5223739288912174 2.7330094283517514e-07 -0.009149783720052125 +0.0604 0.522409857129372 0.5224099717419413 2.8179771414948984e-07 -0.009164847480292901 +0.0605 0.5224459011802967 0.5224460110340836 2.9026113043673085e-07 -0.009179910821128163 +0.0606 0.5224819418079988 0.5224820467669835 2.9869009227079246e-07 -0.009194973741880217 +0.060700000000000004 0.522517979011333 0.5225180789399893 3.0708350340358237e-07 -0.009210036241871455 +0.06080000000000001 0.522554012789145 0.5225541075524579 3.1544027126462204e-07 -0.009225098320424329 +0.0609 0.5225900431402728 0.5225901326037563 3.237593065030797e-07 -0.009240159976861381 +0.061 0.522626070063545 0.5226261540932601 3.3203952373717094e-07 -0.009255221210505218 +0.0611 0.5226620935577821 0.5226621720203544 3.40279841332114e-07 -0.00927028202067854 +0.061200000000000004 0.5226981136217971 0.5226981863844331 3.4847918153890767e-07 -0.009285342406704108 +0.06130000000000001 0.5227341302543932 0.5227341971848996 3.5663647107719854e-07 -0.009300402367904772 +0.0614 0.5227701434543659 0.5227702044211656 3.647506406356804e-07 -0.009315461903603451 +0.0615 0.5228061532205027 0.5228062080926529 3.728206255104727e-07 -0.009330521013123146 +0.0616 0.5228421595515825 0.5228422081987913 3.808453653830757e-07 -0.009345579695786936 +0.061700000000000005 0.5228781624463757 0.5228782047390206 3.8882380481997103e-07 -0.009360637950917978 +0.06180000000000001 0.5229141619036454 0.5229141977127885 3.9675489310608825e-07 -0.009375695777839511 +0.061900000000000004 0.5229501579221452 0.5229501871195522 4.046375845778716e-07 -0.009390753175874844 +0.062 0.5229861505006217 0.5229861729587777 4.1247083859552447e-07 -0.009405810144347361 +0.0621 0.5230221396378127 0.5230221552299398 4.202536198483209e-07 -0.009420866682580534 +0.062200000000000005 0.5230581253324484 0.5230581339325218 4.2798489849338317e-07 -0.00943592278989791 +0.0623 0.5230941075832505 0.5230941090660162 4.3566365010017094e-07 -0.009450978465623107 +0.062400000000000004 0.523130086388933 0.5231300806299239 4.432888560113035e-07 -0.009466033709079833 +0.0625 0.5231660617482021 0.5231660486237548 4.508595032037821e-07 -0.009481088519591877 +0.0626 0.5232020336597557 0.5232020130470272 4.5837458489961236e-07 -0.009496142896483093 +0.0627 0.5232380021222842 0.5232379738992681 4.6583310017722646e-07 -0.009511196839077425 +0.06280000000000001 0.5232739671344698 0.5232739311800128 4.7323405438781663e-07 -0.009526250346698887 +0.06290000000000001 0.5233099286949873 0.5233098848888054 4.805764592108464e-07 -0.009541303418671597 +0.063 0.5233458868025034 0.5233458350251985 4.878593329038505e-07 -0.00955635605431971 +0.0631 0.5233818414556775 0.5233817815887528 4.950817002746799e-07 -0.009571408252967505 +0.0632 0.523417792653161 0.5234177245790375 5.022425928202789e-07 -0.009586460013939289 +0.06330000000000001 0.5234537403935984 0.5234536639956301 5.093410489487304e-07 -0.009601511336559504 +0.06340000000000001 0.5234896846756253 0.5234895998381165 5.163761142845669e-07 -0.009616562220152631 +0.0635 0.5235256254978713 0.5235255321060905 5.233468413357034e-07 -0.009631612664043242 +0.0636 0.5235615628589578 0.5235614607991547 5.30252289826505e-07 -0.00964666266755602 +0.0637 0.5235974967574992 0.523597385916919 5.370915270863641e-07 -0.009661712230015683 +0.06380000000000001 0.523633427192102 0.5236333074590016 5.438636280774567e-07 -0.009676761350747038 +0.06390000000000001 0.5236693541613662 0.5236692254250288 5.505676750339195e-07 -0.009691810029074996 +0.064 0.523705277663884 0.5237051398146351 5.572027582945172e-07 -0.009706858264324542 +0.0641 0.5237411976982407 0.5237410506274622 5.637679759418202e-07 -0.009721906055820712 +0.06420000000000001 0.5237771142630145 0.5237769578631603 5.702624342462936e-07 -0.009736953402888644 +0.0643 0.5238130273567768 0.523812861521387 5.766852473332307e-07 -0.009752000304853604 +0.0644 0.5238489369780917 0.5238487616018076 5.830355379876639e-07 -0.009767046761040843 +0.0645 0.5238848431255162 0.5238846581040949 5.893124371270098e-07 -0.009782092770775769 +0.0646 0.5239207457976011 0.5239205510279298 5.955150842729129e-07 -0.009797138333383824 +0.06470000000000001 0.5239566449928899 0.523956440373 6.016426275512465e-07 -0.009812183448190582 +0.0648 0.5239925407099196 0.5239923261390014 6.076942239419125e-07 -0.009827228114521658 +0.0649 0.5240284329472208 0.5240282083256365 6.136690391400634e-07 -0.009842272331702756 +0.065 0.5240643217033168 0.5240640869326155 6.19566247916925e-07 -0.009857316099059639 +0.0651 0.5241002069767253 0.5240999619596559 6.25385034147552e-07 -0.009872359415918236 +0.06520000000000001 0.5241360887659569 0.5241358334064823 6.311245911438945e-07 -0.00988740228160443 +0.0653 0.5241719670695163 0.5241717012728263 6.367841210996872e-07 -0.009902444695444313 +0.0654 0.5242078418859015 0.5242075655584264 6.423628358120936e-07 -0.009917486656763987 +0.0655 0.5242437132136046 0.5242434262630286 6.478599570147736e-07 -0.009932528164889648 +0.0656 0.5242795810511113 0.524279283386385 6.532747158782826e-07 -0.009947569219147585 +0.06570000000000001 0.5243154453969012 0.5243151369282553 6.586063529545605e-07 -0.009962609818864149 +0.0658 0.5243513062494481 0.5243509868884051 6.63854119287155e-07 -0.009977649963365776 +0.0659 0.52438716360722 0.5243868332666075 6.69017275578554e-07 -0.009992689651979025 +0.066 0.5244230174686789 0.5244226760626418 6.740950928563194e-07 -0.010007728884030509 +0.0661 0.5244588678322809 0.5244585152762935 6.790868521955318e-07 -0.010022767658846927 +0.06620000000000001 0.5244947146964766 0.5244943509073551 6.839918448853233e-07 -0.01003780597575505 +0.0663 0.5245305580597106 0.5245301829556248 6.888093729284783e-07 -0.010052843834081733 +0.0664 0.5245663979204227 0.5245660114209076 6.93538748486322e-07 -0.010067881233153903 +0.0665 0.5246022342770467 0.5246018363030144 6.981792946558762e-07 -0.010082918172298623 +0.0666 0.524638067128011 0.5246376576017624 7.027303450257705e-07 -0.010097954650842995 +0.06670000000000001 0.5246738964717389 0.5246734753169747 7.071912442313533e-07 -0.010112990668114226 +0.0668 0.5247097223066488 0.5247092894484803 7.115613472885585e-07 -0.01012802622343958 +0.0669 0.5247455446311537 0.524745099996114 7.158400210927063e-07 -0.010143061316146436 +0.067 0.5247813634436613 0.5247809069597165 7.200266426421464e-07 -0.010158095945562235 +0.0671 0.5248171787425746 0.5248167103391341 7.241206009256373e-07 -0.010173130111014506 +0.06720000000000001 0.5248529905262919 0.5248525101342187 7.281212960341676e-07 -0.010188163811830887 +0.0673 0.5248887987932066 0.5248883063448277 7.320281387723782e-07 -0.010203197047339036 +0.0674 0.5249246035417073 0.5249240989708241 7.358405523238964e-07 -0.010218229816866787 +0.0675 0.5249604047701784 0.5249598880120758 7.395579709190692e-07 -0.010233262119741971 +0.06760000000000001 0.5249962024769991 0.5249956734684563 7.431798405010959e-07 -0.010248293955292571 +0.0677 0.5250319966605449 0.5250314553398441 7.467056187815402e-07 -0.010263325322846618 +0.0678 0.5250677873191867 0.5250672336261227 7.501347751293075e-07 -0.010278356221732232 +0.0679 0.5251035744512913 0.5251030083271808 7.534667907926895e-07 -0.010293386651277643 +0.068 0.5251393580552209 0.5251387794429117 7.567011594544759e-07 -0.010308416610811123 +0.06810000000000001 0.5251751381293344 0.5251745469732135 7.598373861217311e-07 -0.010323446099661083 +0.0682 0.5252109146719862 0.5252103109179891 7.628749882360175e-07 -0.010338475117155937 +0.0683 0.5252466876815272 0.525246071277146 7.658134956178841e-07 -0.01035350366262431 +0.0684 0.5252824571563043 0.5252818280505962 7.68652449800733e-07 -0.01036853173539481 +0.0685 0.5253182230946606 0.5253175812382558 7.7139140552962e-07 -0.010383559334796134 +0.06860000000000001 0.5253539854949361 0.5253533308400454 7.740299291514319e-07 -0.010398586460157117 +0.0687 0.5253897443554671 0.52538907685589 7.765675997251087e-07 -0.01041361311080663 +0.0688 0.5254254996745866 0.5254248192857184 7.790040090771555e-07 -0.010428639286073717 +0.0689 0.5254612514506243 0.5254605581294637 7.813387613575529e-07 -0.010443664985287421 +0.069 0.5254969996819066 0.5254962933870624 7.83571473428335e-07 -0.010458690207776839 +0.06910000000000001 0.525532744366757 0.5255320250584552 7.857017750856343e-07 -0.010473714952871272 +0.0692 0.525568485503496 0.5255677531435865 7.877293088376369e-07 -0.010488739219900034 +0.0693 0.5256042230904414 0.5256034776424042 7.89653729738049e-07 -0.010503763008192552 +0.0694 0.5256399571259079 0.5256391985548599 7.914747062742755e-07 -0.010518786317078295 +0.0695 0.5256756876082079 0.525674915880908 7.931919195347525e-07 -0.01053380914588688 +0.06960000000000001 0.5257114145356511 0.5257106296205069 7.948050638750814e-07 -0.010548831493948002 +0.0697 0.5257471379065444 0.5257463397736177 7.963138465849617e-07 -0.010563853360591364 +0.0698 0.5257828577191929 0.525782046340205 7.977179879992136e-07 -0.010578874745146866 +0.0699 0.5258185739718991 0.5258177493202361 7.990172220528891e-07 -0.010593895646944435 +0.07 0.525854286662964 0.5258534487136811 8.002112955041163e-07 -0.0106089160653141 +0.07010000000000001 0.5258899957906855 0.5258891445205129 8.012999684892108e-07 -0.010623935999585988 +0.0702 0.5259257013533603 0.5259248367407076 8.022830144116533e-07 -0.01063895544909025 +0.0703 0.525961403349283 0.525960525374243 8.031602203306676e-07 -0.010653974413157213 +0.0704 0.525997101776747 0.5259962104211001 8.039313864061093e-07 -0.010668992891117269 +0.0705 0.5260327966340432 0.526031891881262 8.045963263425548e-07 -0.01068401088230085 +0.07060000000000001 0.526068487919462 0.5260675697547139 8.051548673893016e-07 -0.010699028386038556 +0.0707 0.5261041756312916 0.5261032440414432 8.056068502293456e-07 -0.01071404540166101 +0.0708 0.5261398597678193 0.5261389147414395 8.059521293124483e-07 -0.0107290619284989 +0.0709 0.526175540327331 0.5261745818546939 8.061905725220697e-07 -0.010744077965883093 +0.071 0.5262112173081119 0.5262102453811998 8.063220612863908e-07 -0.010759093513144514 +0.07110000000000001 0.5262468907084459 0.5262459053209521 8.063464908558693e-07 -0.010774108569614095 +0.0712 0.526282560526616 0.5262815616739469 8.062637701367059e-07 -0.010789123134622963 +0.0713 0.526318226760905 0.5263172144401826 8.06073821801867e-07 -0.010804137207502312 +0.0714 0.5263538894095945 0.5263528636196586 8.057765819025065e-07 -0.010819150787583366 +0.0715 0.5263895484709654 0.5263885092123751 8.053720008116549e-07 -0.010834163874197495 +0.07160000000000001 0.5264252039432993 0.5264241512183342 8.048600422805308e-07 -0.010849176466676158 +0.0717 0.526460855824876 0.5264597896375385 8.042406842156957e-07 -0.010864188564350875 +0.0718 0.5264965041139764 0.5264954244699919 8.035139178463879e-07 -0.010879200166553261 +0.0719 0.5265321488088807 0.5265310557156987 8.026797486682113e-07 -0.010894211272615063 +0.072 0.5265677899078692 0.5265666833746644 8.017381958325132e-07 -0.010909221881868065 +0.07210000000000001 0.5266034274092224 0.5266023074468948 8.00689292257406e-07 -0.010924231993644173 +0.0722 0.5266390613112211 0.5266379279323962 7.995330849608351e-07 -0.010939241607275342 +0.0723 0.5266746916121463 0.5266735448311753 7.982696348940443e-07 -0.010954250722093679 +0.0724 0.5267103183102795 0.5267091581432394 7.968990165529988e-07 -0.010969259337431326 +0.0725 0.5267459414039029 0.5267447678685951 7.954213185334957e-07 -0.010984267452620511 +0.07260000000000001 0.5267815608912993 0.5267803740072501 7.93836643531165e-07 -0.010999275066993615 +0.0727 0.5268171767707529 0.5268159765592112 7.921451080084019e-07 -0.01101428217988309 +0.0728 0.5268527890405478 0.5268515755244857 7.903468419168114e-07 -0.011029288790621445 +0.0729 0.5268883976989698 0.5268871709030798 7.88441989696409e-07 -0.011044294898541297 +0.073 0.5269240027443057 0.5269227626949999 7.864307094984646e-07 -0.01105930050297534 +0.07310000000000001 0.5269596041748437 0.5269583509002519 7.843131731299913e-07 -0.011074305603256408 +0.0732 0.5269952019888732 0.5269939355188407 7.820895665533456e-07 -0.011089310198717362 +0.0733 0.5270307961846852 0.5270295165507706 7.797600893866274e-07 -0.011104314288691209 +0.0734 0.5270663867605722 0.5270650939960451 7.773249552922579e-07 -0.011119317872511005 +0.0735 0.5271019737148283 0.5271006678546669 7.747843916439123e-07 -0.011134320949509918 +0.07360000000000001 0.5271375570457499 0.5271362381266372 7.721386397485652e-07 -0.011149323519021238 +0.0737 0.527173136751635 0.5271718048119562 7.693879547909788e-07 -0.01116432558037826 +0.07379999999999999 0.5272087128307835 0.5272073679106232 7.665326056116584e-07 -0.011179327132914453 +0.07390000000000001 0.5272442852814978 0.5272429274226352 7.635728748733861e-07 -0.01119432817596337 +0.074 0.5272798541020824 0.5272784833479888 7.605090590057095e-07 -0.011209328708858641 +0.07410000000000001 0.5273154192908442 0.5273140356866781 7.573414681494306e-07 -0.01122432873093398 +0.0742 0.5273509808460927 0.5273495844386957 7.540704262676279e-07 -0.01123932824152319 +0.07429999999999999 0.5273865387661397 0.5273851296040323 7.506962708681009e-07 -0.011254327239960138 +0.07440000000000001 0.5274220930493002 0.5274206711826765 7.472193530588811e-07 -0.011269325725578889 +0.0745 0.5274576436938918 0.5274562091746153 7.436400376592545e-07 -0.011284323697713483 +0.07460000000000001 0.5274931906982349 0.5274917435798332 7.399587030887389e-07 -0.011299321155698129 +0.0747 0.527528734060653 0.527527274398312 7.361757414781067e-07 -0.011314318098867111 +0.07479999999999999 0.527564273779473 0.5275628016300319 7.322915583363176e-07 -0.011329314526554774 +0.07490000000000001 0.5275998098530249 0.52759832527497 7.283065723839854e-07 -0.011344310438095579 +0.075 0.5276353422796423 0.5276338453331006 7.242212162750228e-07 -0.011359305832824119 +0.07510000000000001 0.5276708710576619 0.5276693618043959 7.200359356529518e-07 -0.011374300710074982 +0.0752 0.5277063961854241 0.5277048746888248 7.157511897060154e-07 -0.011389295069182966 +0.07529999999999999 0.5277419176612734 0.5277403839863534 7.113674507230883e-07 -0.011404288909482908 +0.07540000000000001 0.5277774354835579 0.5277758896969444 7.068852045932772e-07 -0.011419282230309719 +0.0755 0.5278129496506294 0.527811391820558 7.02304950084276e-07 -0.011434275030998427 +0.07560000000000001 0.527848460160844 0.5278468903571504 6.976271994529881e-07 -0.011449267310884137 +0.0757 0.5278839670125617 0.5278823853066745 6.928524777793932e-07 -0.011464259069302086 +0.07579999999999999 0.5279194702041473 0.5279178766690803 6.879813234106358e-07 -0.011479250305587569 +0.07590000000000001 0.5279549697339696 0.5279533644443134 6.830142874059142e-07 -0.01149424101907598 +0.076 0.5279904656004017 0.5279888486323162 6.779519340915918e-07 -0.01150923120910285 +0.07610000000000001 0.5280259578018216 0.5280243292330271 6.727948405060857e-07 -0.011524220875003755 +0.0762 0.5280614463366118 0.5280598062463807 6.675435963998666e-07 -0.011539210016114377 +0.07629999999999999 0.5280969312031595 0.5280952796723073 6.621988045685256e-07 -0.01155419863177048 +0.07640000000000001 0.5281324123998571 0.5281307495107331 6.567610802976631e-07 -0.011569186721307974 +0.0765 0.528167889925102 0.5281662157615805 6.512310514739106e-07 -0.011584174284062826 +0.07660000000000002 0.5282033637772963 0.5282016784247668 6.456093585294198e-07 -0.011599161319371094 +0.0767 0.5282388339548476 0.5282371375002055 6.398966546083962e-07 -0.011614147826568933 +0.07680000000000001 0.5282743004561689 0.5282725929878052 6.340936050119872e-07 -0.011629133804992621 +0.07690000000000001 0.5283097632796782 0.5283080448874699 6.282008874758382e-07 -0.011644119253978485 +0.077 0.5283452224237996 0.5283434931990989 6.222191920590703e-07 -0.011659104172863 +0.0771 0.5283806778869622 0.5283789379225866 6.161492209777464e-07 -0.011674088560982693 +0.0772 0.5284161296676015 0.5284143790578224 6.099916883828271e-07 -0.011689072417674223 +0.07730000000000001 0.5284515777641585 0.5284498166046908 6.037473206932376e-07 -0.011704055742274344 +0.07740000000000001 0.5284870221750797 0.5284852505630707 5.974168560962667e-07 -0.011719038534119836 +0.0775 0.5285224628988182 0.5285206809328362 5.910010447141012e-07 -0.011734020792547668 +0.0776 0.528557899933833 0.5285561077138559 5.845006486593363e-07 -0.011749002516894853 +0.0777 0.5285933332785893 0.5285915309059929 5.77916441368842e-07 -0.011763983706498508 +0.07780000000000001 0.5286287629315586 0.5286269505091046 5.71249208020097e-07 -0.011778964360695872 +0.07790000000000001 0.5286641888912191 0.528662366523043 5.644997454756773e-07 -0.011793944478824245 +0.078 0.528699611156055 0.5286977789476542 5.576688616726333e-07 -0.011808924060221056 +0.0781 0.5287350297245577 0.5287331877827787 5.507573761220907e-07 -0.011823903104223791 +0.0782 0.5287704445952244 0.5287685930282505 5.437661195761834e-07 -0.01183888161017008 +0.07830000000000001 0.52880585576656 0.5288039946838982 5.366959338892752e-07 -0.011853859577397624 +0.07840000000000001 0.528841263237076 0.528839392749544 5.295476718514269e-07 -0.011868837005244215 +0.0785 0.5288766670052907 0.5288747872250036 5.223221972161518e-07 -0.011883813893047762 +0.0786 0.5289120670697295 0.528910178110087 5.150203847004153e-07 -0.011898790240146269 +0.0787 0.5289474634289252 0.5289455654045973 5.076431197348352e-07 -0.01191376604587782 +0.07880000000000001 0.5289828560814176 0.5289809491083313 5.001912982138812e-07 -0.01192874130958061 +0.07890000000000001 0.529018245025754 0.529016329221079 4.926658266346529e-07 -0.011943716030592928 +0.079 0.529053630260489 0.5290517057426241 4.850676219581018e-07 -0.011958690208253171 +0.0791 0.5290890117841848 0.5290870786727434 4.773976114702538e-07 -0.011973663841899818 +0.0792 0.5291243895954109 0.5291224480112067 4.696567325324086e-07 -0.011988636930871446 +0.07930000000000001 0.5291597636927451 0.529157813757777 4.618459328031843e-07 -0.012003609474506766 +0.07940000000000001 0.5291951340747726 0.5291931759122104 4.539661697111619e-07 -0.012018581472144541 +0.0795 0.5292305007400862 0.5292285344742556 4.4601841048264035e-07 -0.012033552923123653 +0.0796 0.5292658636872872 0.5292638894436543 4.380036324469483e-07 -0.012048523826783062 +0.07970000000000001 0.5293012229149845 0.529299240820141 4.2992282220377653e-07 -0.01206349418246188 +0.07980000000000001 0.5293365784217953 0.529334588603443 4.2177697590073393e-07 -0.012078463989499265 +0.0799 0.5293719302063449 0.5293699327932796 4.1356709931661406e-07 -0.012093433247234501 +0.08 0.5294072782672669 0.5294052733893629 4.0529420719526144e-07 -0.012108401955006965 +0.0801 0.5294426226032033 0.5294406103913979 3.9695932349537166e-07 -0.012123370112156126 +0.08020000000000001 0.5294779632128045 0.5294759437990813 3.885634813349803e-07 -0.012138337718021575 +0.08030000000000001 0.5295133000947293 0.5295112736121019 3.8010772260288483e-07 -0.012153304771942963 +0.0804 0.5295486332476451 0.5295465998301415 3.715930979586446e-07 -0.01216827127326007 +0.0805 0.529583962670228 0.5295819224528735 3.6302066669380295e-07 -0.012183237221312768 +0.0806 0.5296192883611628 0.5296172414799631 3.543914965931094e-07 -0.012198202615441031 +0.08070000000000001 0.5296546103191433 0.529652556911068 3.4570666396227523e-07 -0.012213167454984943 +0.08080000000000001 0.5296899285428717 0.5296878687458376 3.3696725321163967e-07 -0.01222813173928467 +0.0809 0.5297252430310596 0.5297231769839128 3.281743567729034e-07 -0.012243095467680487 +0.081 0.5297605537824275 0.5297584816249266 3.193290752379063e-07 -0.01225805863951276 +0.0811 0.5297958607957045 0.5297937826685039 3.104325168590272e-07 -0.012273021254121962 +0.08120000000000001 0.5298311640696296 0.5298290801142607 3.0148579779898377e-07 -0.01228798331084868 +0.08130000000000001 0.5298664636029506 0.5298643739618047 2.92490041603477e-07 -0.012302944809033586 +0.0814 0.5299017593944247 0.5298996642107351 2.834463792844577e-07 -0.01231790574801745 +0.0815 0.5299370514428183 0.5299349508606428 2.7435594915359296e-07 -0.01233286612714115 +0.0816 0.5299723397469073 0.5299702339111098 2.652198967251218e-07 -0.012347825945745674 +0.08170000000000001 0.5300076243054771 0.5300055133617091 2.56039374396666e-07 -0.01236278520317209 +0.08180000000000001 0.5300429051173224 0.5300407892120055 2.468155414908635e-07 -0.01237774389876158 +0.0819 0.5300781821812479 0.5300760614615546 2.375495640333236e-07 -0.012392702031855427 +0.082 0.5301134554960679 0.5301113301099035 2.2824261462772721e-07 -0.012407659601795018 +0.0821 0.5301487250606058 0.53014659515659 2.188958722615375e-07 -0.012422616607921839 +0.08220000000000001 0.5301839908736953 0.5301818566011427 2.095105221949778e-07 -0.012437573049577464 +0.08230000000000001 0.5302192529341798 0.5302171144430816 2.0008775578062021e-07 -0.012452528926103596 +0.0824 0.5302545112409128 0.5302523686819174 1.9062877046338578e-07 -0.012467484236842012 +0.0825 0.5302897657927572 0.5302876193171517 1.8113476937808848e-07 -0.012482438981134606 +0.0826 0.5303250165885866 0.5303228663482769 1.7160696130780195e-07 -0.012497393158323378 +0.08270000000000001 0.5303602636272838 0.5303581097747758 1.620465606561039e-07 -0.012512346767750425 +0.08280000000000001 0.5303955069077424 0.5303933495961227 1.5245478712788696e-07 -0.012527299808757941 +0.0829 0.5304307464288656 0.5304285858117816 1.4283286567384756e-07 -0.012542252280688233 +0.083 0.5304659821895671 0.5304638184212075 1.3318202633783027e-07 -0.012557204182883695 +0.08310000000000001 0.5305012141887706 0.530499047423846 1.2350350389600528e-07 -0.012572155514686845 +0.0832 0.5305364424254105 0.5305342728191335 1.1379853798176853e-07 -0.012587106275440295 +0.08330000000000001 0.5305716668984308 0.5305694946064962 1.0406837277349146e-07 -0.012602056464486745 +0.0834 0.5306068876067862 0.5306047127853508 9.431425690431539e-08 -0.012617006081169014 +0.0835 0.530642104549442 0.530639927355105 8.453744324704582e-08 -0.01263195512483002 +0.08360000000000001 0.5306773177253739 0.5306751383151561 7.473918878925234e-08 -0.012646903594812796 +0.0837 0.5307125271335674 0.5307103456648923 6.49207544320407e-08 -0.012661851490460455 +0.08380000000000001 0.5307477327730195 0.5307455494036916 5.508340487903052e-08 -0.012676798811116222 +0.0839 0.5307829346427368 0.5307807495309226 4.522840842818843e-08 -0.012691745556123442 +0.084 0.5308181327417375 0.5308159460459437 3.535703686774472e-08 -0.012706691724825546 +0.08410000000000001 0.5308533270690494 0.5308511389481042 2.5470565240270915e-08 -0.012721637316566071 +0.0842 0.5308885176237113 0.5308863282367424 1.557027173165748e-08 -0.01273658233068866 +0.08430000000000001 0.530923704404773 0.5309215139111872 5.657437501110918e-09 -0.012751526766537067 +0.0844 0.5309588874112946 0.5309566959707582 -4.2666535270130534e-09 -0.012766470623455135 +0.0845 0.5309940666423472 0.5309918744147644 -1.4200714770762346e-08 -0.012781413900786825 +0.08460000000000001 0.5310292420970123 0.5310270492425045 -2.4143457207428942e-08 -0.0127963565978762 +0.0847 0.5310644137743825 0.5310622204532682 -3.409358950018371e-08 -0.012811298714067427 +0.08480000000000001 0.531099581673561 0.5310973880463344 -4.404981819149806e-08 -0.012826240248704771 +0.0849 0.5311347457936618 0.5311325520209721 -5.4010847855799626e-08 -0.012841181201132604 +0.085 0.5311699061338102 0.5311677123764401 -6.397538127728142e-08 -0.01285612157069541 +0.08510000000000001 0.5312050626931417 0.5312028691119873 -7.394211962163943e-08 -0.012871061356737771 +0.0852 0.531240215470803 0.5312380222268525 -8.390976259479987e-08 -0.012886000558604373 +0.08530000000000001 0.5312753644659518 0.5312731717202642 -9.387700862679982e-08 -0.012900939175640011 +0.0854 0.5313105096777565 0.5313083175914413 -1.0384255501316719e-07 -0.012915877207189591 +0.0855 0.5313456511053967 0.5313434598395915 -1.1380509812655704e-07 -0.012930814652598113 +0.08560000000000001 0.5313807887480626 0.5313785984639134 -1.2376333356073355e-07 -0.012945751511210688 +0.0857 0.5314159226049557 0.5314137334635949 -1.3371595630057298e-07 -0.01296068778237254 +0.08580000000000002 0.531451052675288 0.5314488648378135 -1.4366166090767907e-07 -0.012975623465428979 +0.0859 0.531486178958283 0.5314839925857369 -1.5359914166956923e-07 -0.012990558559725435 +0.086 0.5315213014531748 0.5315191167065225 -1.6352709279743305e-07 -0.013005493064607446 +0.08610000000000001 0.5315564201592085 0.5315542371993174 -1.7344420857184906e-07 -0.013020426979420647 +0.0862 0.5315915350756405 0.5315893540632585 -1.8334918357176822e-07 -0.01303536030351079 +0.08630000000000002 0.5316266462017378 0.5316244672974724 -1.9324071275084176e-07 -0.013050293036223721 +0.0864 0.5316617535367789 0.5316595769010759 -2.0311749170109916e-07 -0.013065225176905402 +0.0865 0.5316968570800525 0.5316946828731749 -2.1297821673621486e-07 -0.013080156724901893 +0.08660000000000001 0.5317319568308592 0.5317297852128656 -2.2282158522457518e-07 -0.013095087679559372 +0.0867 0.5317670527885099 0.5317648839192338 -2.3264629551988936e-07 -0.013110018040224115 +0.08680000000000002 0.5318021449523268 0.531799978991355 -2.4245104733588985e-07 -0.01312494780624251 +0.0869 0.5318372333216432 0.5318350704282946 -2.522345418504157e-07 -0.013139876976961047 +0.087 0.531872317895803 0.5318701582291078 -2.619954818927628e-07 -0.013154805551726316 +0.08710000000000001 0.5319073986741613 0.5319052423928398 -2.717325720963393e-07 -0.01316973352988504 +0.0872 0.5319424756560841 0.531940322918525 -2.814445190374437e-07 -0.013184660910784025 +0.08730000000000002 0.5319775488409482 0.5319753998051883 -2.9113003144343175e-07 -0.013199587693770186 +0.0874 0.5320126182281416 0.532010473051844 -3.007878204425163e-07 -0.013214513878190563 +0.0875 0.5320476838170632 0.5320455426574966 -3.104165995915231e-07 -0.013229439463392278 +0.08760000000000001 0.532082745607123 0.5320806086211403 -3.2001508519508004e-07 -0.013244364448722595 +0.0877 0.532117803597741 0.532115670941759 -3.295819963056168e-07 -0.013259288833528844 +0.08780000000000002 0.5321528577883489 0.5321507296183268 -3.391160550980654e-07 -0.013274212617158498 +0.0879 0.5321879081783889 0.5321857846498073 -3.48615986814349e-07 -0.013289135798959123 +0.088 0.5322229547673144 0.5322208360351549 -3.580805201519599e-07 -0.013304058378278392 +0.08810000000000001 0.5322579975545891 0.5322558837733131 -3.6750838731947066e-07 -0.01331898035446409 +0.0882 0.532293036539688 0.5322909278632159 -3.768983241891899e-07 -0.013333901726864114 +0.08830000000000002 0.5323280717220962 0.5323259683037868 -3.862490705885957e-07 -0.013348822494826457 +0.0884 0.5323631031013101 0.5323610050939399 -3.955593703142135e-07 -0.013363742657699238 +0.0885 0.5323981306768366 0.532396038232579 -4.0482797136753845e-07 -0.013378662214830661 +0.08860000000000001 0.5324331544481933 0.5324310677185982 -4.140536262742245e-07 -0.013393581165569069 +0.0887 0.5324681744149083 0.5324660935508815 -4.2323509191755093e-07 -0.01340849950926289 +0.08880000000000002 0.5325031905765207 0.5325011157283035 -4.3237112995475613e-07 -0.013423417245260666 +0.0889 0.5325382029325797 0.5325361342497287 -4.414605071778599e-07 -0.013438334372911063 +0.089 0.5325732114826452 0.5325711491140118 -4.5050199504181876e-07 -0.013453250891562832 +0.08910000000000001 0.5326082162262877 0.5326061603199977 -4.594943704139265e-07 -0.013468166800564858 +0.0892 0.5326432171630882 0.5326411678665219 -4.684364156848364e-07 -0.01348308209926611 +0.08930000000000002 0.532678214292638 0.53267617175241 -4.773269186852946e-07 -0.013497996787015694 +0.08940000000000001 0.5327132076145387 0.5327111719764782 -4.86164672824918e-07 -0.013512910863162792 +0.0895 0.5327481971284025 0.5327461685375328 -4.949484776195501e-07 -0.013527824327056731 +0.08960000000000001 0.5327831828338518 0.5327811614343708 -5.036771385802385e-07 -0.013542737178046932 +0.0897 0.5328181647305194 0.5328161506657799 -5.123494674075246e-07 -0.013557649415482934 +0.0898 0.5328531428180476 0.532851136230538 -5.209642821579763e-07 -0.013572561038714355 +0.08990000000000001 0.5328881170960901 0.5328861181274138 -5.295204075772553e-07 -0.013587472047090987 +0.09 0.5329230875643096 0.5329210963551664 -5.380166750168502e-07 -0.01360238243996265 +0.09010000000000001 0.5329580542223795 0.532956070912546 -5.464519226561215e-07 -0.013617292216679339 +0.0902 0.532993017069983 0.5329910417982935 -5.548249957798568e-07 -0.013632201376591125 +0.0903 0.5330279761068133 0.5330260090111402 -5.631347468337822e-07 -0.013647109919048212 +0.09040000000000001 0.5330629313325732 0.5330609725498089 -5.71380035646607e-07 -0.013662017843400901 +0.0905 0.5330978827469759 0.5330959324130126 -5.795597294855348e-07 -0.013676925148999609 +0.09060000000000001 0.5331328303497439 0.5331308885994561 -5.87672703278308e-07 -0.01369183183519486 +0.0907 0.5331677741406099 0.5331658411078345 -5.957178399185192e-07 -0.013706737901337297 +0.0908 0.533202714119316 0.5332007899368344 -6.036940301823446e-07 -0.013721643346777666 +0.09090000000000001 0.5332376502856139 0.5332357350851336 -6.116001728395659e-07 -0.013736548170866834 +0.091 0.5332725826392649 0.5332706765514007 -6.194351752919491e-07 -0.013751452372955764 +0.09110000000000001 0.5333075111800399 0.533305614334296 -6.271979531569105e-07 -0.01376635595239554 +0.0912 0.5333424359077191 0.5333405484324711 -6.348874306560948e-07 -0.013781258908537356 +0.0913 0.5333773568220923 0.5333754788445688 -6.425025406708862e-07 -0.01379616124073253 +0.09140000000000001 0.5334122739229581 0.5334104055692238 -6.500422251864979e-07 -0.01381106294833249 +0.0915 0.5334471872101247 0.5334453286050617 -6.575054350976828e-07 -0.013825964030688748 +0.09160000000000001 0.5334820966834096 0.5334802479507 -6.64891130569556e-07 -0.013840864487152944 +0.0917 0.533517002342639 0.5335151636047485 -6.721982810098392e-07 -0.013855764317076856 +0.0918 0.5335519041876482 0.5335500755658076 -6.794258653741725e-07 -0.013870663519812323 +0.09190000000000001 0.5335868022182818 0.5335849838324707 -6.865728721106024e-07 -0.01388556209471134 +0.092 0.533621696434393 0.5336198884033222 -6.936382998812274e-07 -0.013900460041126009 +0.09210000000000002 0.5336565868358434 0.5336547892769389 -7.006211566740195e-07 -0.013915357358408523 +0.0922 0.533691473422504 0.5336896864518897 -7.07520460913047e-07 -0.013930254045911201 +0.09230000000000001 0.5337263561942542 0.5337245799267357 -7.143352411254078e-07 -0.013945150102986493 +0.09240000000000001 0.5337612351509818 0.5337594697000299 -7.210645361355184e-07 -0.013960045528986909 +0.0925 0.5337961102925832 0.5337943557703176 -7.277073953981805e-07 -0.013974940323265135 +0.0926 0.5338309816189631 0.5338292381361369 -7.342628787210259e-07 -0.01398983448517392 +0.0927 0.533865849130035 0.5338641167960182 -7.407300569028941e-07 -0.014004728014066176 +0.09280000000000001 0.5339007128257198 0.5338989917484844 -7.471080114562767e-07 -0.014019620909294872 +0.09290000000000001 0.5339355727059469 0.5339338629920507 -7.533958351624293e-07 -0.01403451317021311 +0.093 0.533970428770654 0.5339687305252255 -7.595926315717705e-07 -0.014049404796174132 +0.0931 0.5340052810197866 0.53400359434651 -7.656975157810386e-07 -0.014064295786531289 +0.0932 0.5340401294532982 0.5340384544543982 -7.717096142667579e-07 -0.014079186140638045 +0.09330000000000001 0.5340749740711496 0.5340733108473766 -7.776280648297274e-07 -0.0140940758578479 +0.09340000000000001 0.53410981487331 0.5341081635239256 -7.834520173166659e-07 -0.014108964937514585 +0.0935 0.5341446518597559 0.5341430124825183 -7.891806330651008e-07 -0.014123853378991903 +0.0936 0.5341794850304711 0.534177857721621 -7.948130854029678e-07 -0.01413874118163374 +0.0937 0.5342143143854472 0.5342126992396934 -8.003485595931004e-07 -0.014153628344794134 +0.09380000000000001 0.534249139924683 0.5342475370351889 -8.057862533328297e-07 -0.01416851486782721 +0.09390000000000001 0.5342839616481843 0.5342823711065545 -8.111253761433623e-07 -0.014183400750087222 +0.094 0.5343187795559644 0.5343172014522303 -8.163651504244918e-07 -0.014198285990928533 +0.0941 0.5343535936480432 0.5343520280706506 -8.215048107329537e-07 -0.014213170589705632 +0.0942 0.5343884039244481 0.5343868509602434 -8.265436041154928e-07 -0.0142280545457731 +0.09430000000000001 0.5344232103852129 0.5344216701194306 -8.314807908860189e-07 -0.01424293785848569 +0.09440000000000001 0.5344580130303783 0.5344564855466283 -8.363156439039621e-07 -0.01425782052719819 +0.0945 0.5344928118599918 0.5344912972402467 -8.41047448740806e-07 -0.014272702551265566 +0.0946 0.5345276068741068 0.53452610519869 -8.456755043462216e-07 -0.014287583930042863 +0.0947 0.5345623980727842 0.5345609094203572 -8.501991227705119e-07 -0.014302464662885256 +0.09480000000000001 0.5345971854560903 0.5345957099036411 -8.546176293866559e-07 -0.01431734474914802 +0.09490000000000001 0.5346319690240977 0.5346305066469298 -8.589303626682643e-07 -0.014332224188186561 +0.095 0.5346667487768857 0.5346652996486055 -8.631366748002023e-07 -0.014347102979356402 +0.0951 0.534701524714539 0.5347000889070456 -8.672359314565448e-07 -0.01436198112201318 +0.0952 0.5347362968371489 0.5347348744206222 -8.712275121891544e-07 -0.014376858615512701 +0.09530000000000001 0.5347710651448114 0.5347696561877022 -8.751108100391036e-07 -0.014391735459210759 +0.09540000000000001 0.5348058296376293 0.5348044342066478 -8.788852319252527e-07 -0.014406611652463354 +0.0955 0.5348405903157105 0.5348392084758166 -8.825501988662943e-07 -0.01442148719462661 +0.0956 0.5348753471791681 0.5348739789935609 -8.861051460917757e-07 -0.014436362085056727 +0.09570000000000001 0.5349101002281209 0.5349087457582292 -8.89549522264943e-07 -0.014451236323110045 +0.09580000000000001 0.5349448494626927 0.5349435087681652 -8.928827909260306e-07 -0.01446610990814301 +0.0959 0.5349795948830129 0.5349782680217081 -8.961044295485721e-07 -0.014480982839512175 +0.096 0.5350143364892155 0.5350130235171933 -8.992139305386004e-07 -0.01449585511657427 +0.0961 0.5350490742814389 0.5350477752529514 -9.02210800290959e-07 -0.014510726738686048 +0.09620000000000001 0.5350838082598274 0.53508252322731 -9.050945597999238e-07 -0.014525597705204436 +0.09630000000000001 0.5351185384245292 0.5351172674385919 -9.078647447702259e-07 -0.014540468015486524 +0.0964 0.535153264775697 0.5351520078851164 -9.105209058390962e-07 -0.014555337668889374 +0.0965 0.5351879873134886 0.5351867445651999 -9.130626080211535e-07 -0.014570206664770331 +0.0966 0.5352227060380652 0.5352214774771541 -9.154894313190276e-07 -0.014585075002486753 +0.09670000000000001 0.5352574209495927 0.5352562066192883 -9.178009706123369e-07 -0.014599942681396166 +0.09680000000000001 0.5352921320482411 0.5352909319899077 -9.19996835935244e-07 -0.014614809700856164 +0.0969 0.5353268393341839 0.5353256535873152 -9.220766523099222e-07 -0.01462967606022448 +0.097 0.5353615428075991 0.5353603714098097 -9.240400599130894e-07 -0.014644541758858971 +0.0971 0.5353962424686678 0.5353950854556881 -9.258867143535632e-07 -0.014659406796117685 +0.09720000000000001 0.5354309383175753 0.5354297957232441 -9.276162858395942e-07 -0.014674271171358678 +0.09730000000000001 0.5354656303545092 0.5354645022107685 -9.292284604001111e-07 -0.014689134883940093 +0.0974 0.5355003185796618 0.5354992049165498 -9.307229392185867e-07 -0.014703997933220343 +0.0975 0.5355350029932276 0.5355339038388744 -9.320994390216164e-07 -0.014718860318557837 +0.0976 0.5355696835954051 0.5355685989760262 -9.333576919123843e-07 -0.014733722039311198 +0.09770000000000001 0.5356043603863947 0.5356032903262861 -9.344974455371968e-07 -0.01474858309483907 +0.09780000000000001 0.5356390333664003 0.5356379778879343 -9.355184631409941e-07 -0.014763443484500255 +0.0979 0.5356737025356282 0.5356726616592483 -9.36420523733883e-07 -0.014778303207653687 +0.098 0.5357083678942877 0.5357073416385041 -9.372034217580705e-07 -0.014793162263658394 +0.0981 0.53574302944259 0.5357420178239758 -9.378669673654194e-07 -0.014808020651873583 +0.09820000000000001 0.5357776871807489 0.535776690213936 -9.384109865839818e-07 -0.014822878371658516 +0.09830000000000001 0.5358123411089807 0.5358113588066562 -9.388353212624878e-07 -0.014837735422372584 +0.0984 0.5358469912275032 0.5358460236004065 -9.391398289593234e-07 -0.014852591803375344 +0.0985 0.5358816375365363 0.5358806845934552 -9.393243829980413e-07 -0.014867447514026334 +0.09860000000000001 0.5359162800363018 0.5359153417840707 -9.393888728004285e-07 -0.01488230255368543 +0.0987 0.5359509187270233 0.5359499951705196 -9.393332035534385e-07 -0.014897156921712463 +0.09880000000000001 0.5359855536089257 0.5359846447510683 -9.391572964867478e-07 -0.014912010617467459 +0.0989 0.5360201846822356 0.5360192905239822 -9.388610888172444e-07 -0.014926863640310501 +0.099 0.5360548119471804 0.5360539324875266 -9.384445336935165e-07 -0.014941715989601846 +0.09910000000000001 0.5360894354039892 0.5360885706399662 -9.379076003623865e-07 -0.01495656766470188 +0.0992 0.5361240550528918 0.5361232049795652 -9.372502738913546e-07 -0.01497141866497106 +0.09930000000000001 0.5361586708941193 0.5361578355045877 -9.364725556681996e-07 -0.01498626898976998 +0.0994 0.5361932829279026 0.5361924622132986 -9.355744630124008e-07 -0.015001118638459389 +0.0995 0.5362278911544744 0.5362270851039623 -9.34556029341671e-07 -0.015015967610400117 +0.09960000000000001 0.5362624955740674 0.5362617041748434 -9.334173043940019e-07 -0.015030815904953105 +0.0997 0.5362970961869145 0.5362963194242074 -9.32158353339485e-07 -0.01504566352147947 +0.09980000000000001 0.5363316929932489 0.5363309308503198 -9.307792583346242e-07 -0.01506051045934036 +0.0999 0.5363662859933042 0.5363655384514474 -9.292801172455789e-07 -0.015075356717897177 +0.1 0.5364008751873134 0.5364001422258572 -9.276610441477651e-07 -0.01509020229651132 +0.10010000000000001 0.5364354605755103 0.5364347421718174 -9.259221688817654e-07 -0.015105047194544375 +0.1002 0.5364700421581274 0.5364693382875976 -9.24063637608441e-07 -0.015119891411358007 +0.10030000000000001 0.5365046199353973 0.5365039305714681 -9.220856129754651e-07 -0.01513473494631406 +0.1004 0.536539193907552 0.5365385190217007 -9.199882733956777e-07 -0.01514957779877446 +0.1005 0.5365737640748227 0.5365731036365688 -9.177718133246415e-07 -0.015164419968101245 +0.10060000000000001 0.5366083304374398 0.5366076844143476 -9.154364433716644e-07 -0.015179261453656624 +0.1007 0.5366428929956328 0.5366422613533135 -9.129823901887768e-07 -0.015194102254802867 +0.10080000000000001 0.5366774517496302 0.5366768344517451 -9.104098968037988e-07 -0.015208942370902374 +0.1009 0.5367120066996591 0.5367114037079229 -9.077192218986951e-07 -0.015223781801317705 +0.101 0.5367465578459454 0.5367459691201297 -9.049106402536644e-07 -0.015238620545411542 +0.10110000000000001 0.5367811051887134 0.5367805306866507 -9.019844429136725e-07 -0.015253458602546639 +0.1012 0.5368156487281858 0.536815088405773 -8.989409364668077e-07 -0.015268295972085944 +0.10130000000000002 0.5368501884645837 0.5368496422757866 -8.957804438214367e-07 -0.015283132653392468 +0.1014 0.5368847243981262 0.5368841922949841 -8.925033038176267e-07 -0.015297968645829364 +0.1015 0.5369192565290306 0.5369187384616609 -8.891098707275447e-07 -0.01531280394875993 +0.10160000000000001 0.5369537848575116 0.5369532807741153 -8.856005153101698e-07 -0.015327638561547558 +0.1017 0.536988309383782 0.5369878192306485 -8.819756237010701e-07 -0.015342472483555754 +0.10180000000000002 0.537022830108052 0.5370223538295654 -8.782355980785361e-07 -0.015357305714148152 +0.1019 0.5370573470305294 0.5370568845691737 -8.743808563305144e-07 -0.015372138252688529 +0.102 0.5370918601514193 0.5370914114477846 -8.704118318880738e-07 -0.015386970098540776 +0.10210000000000001 0.5371263694709243 0.5371259344637133 -8.663289740584723e-07 -0.015401801251068954 +0.1022 0.5371608749892435 0.5371604536152782 -8.621327474700458e-07 -0.01541663170963713 +0.10230000000000002 0.5371953767065734 0.537194968900802 -8.578236327383415e-07 -0.015431461473609616 +0.1024 0.5372298746231071 0.5372294803186111 -8.534021260220293e-07 -0.015446290542350784 +0.1025 0.5372643687390346 0.537263987867036 -8.488687383567672e-07 -0.015461118915225142 +0.10260000000000001 0.537298859054542 0.5372984915444116 -8.442239968764476e-07 -0.015475946591597345 +0.1027 0.5373333455698123 0.5373329913490769 -8.39468443647462e-07 -0.015490773570832117 +0.10280000000000002 0.5373678282850247 0.5373674872793756 -8.346026361683023e-07 -0.01550559985229435 +0.1029 0.5374023072003546 0.5374019793336557 -8.296271473140493e-07 -0.015520425435349062 +0.103 0.5374367823159734 0.5374364675102704 -8.245425651143279e-07 -0.015535250319361356 +0.10310000000000001 0.5374712536320483 0.5374709518075779 -8.193494924202405e-07 -0.015550074503696498 +0.1032 0.5375057211487424 0.5375054322239404 -8.140485474039671e-07 -0.015564897987719884 +0.10330000000000002 0.5375401848662146 0.5375399087577264 -8.086403631701877e-07 -0.015579720770796996 +0.1034 0.5375746447846191 0.5375743814073088 -8.031255878115928e-07 -0.015594542852293492 +0.1035 0.537609100904106 0.5376088501710664 -7.975048841868393e-07 -0.015609364231575107 +0.10360000000000001 0.53764355322482 0.5376433150473829 -7.917789296985056e-07 -0.015624184908007717 +0.1037 0.5376780017469014 0.5376777760346485 -7.859484170147368e-07 -0.01563900488095731 +0.10380000000000002 0.5377124464704855 0.5377122331312583 -7.800140529035104e-07 -0.01565382414979004 +0.1039 0.5377468873957028 0.5377466863356135 -7.739765587877478e-07 -0.01566864271387214 +0.104 0.537781324522678 0.5377811356461215 -7.678366706342921e-07 -0.01568346057257 +0.10410000000000001 0.537815757851531 0.5378155810611958 -7.615951386208408e-07 -0.015698277725250127 +0.1042 0.537850187382376 0.5378500225792557 -7.552527273024801e-07 -0.01571309417127915 +0.10430000000000002 0.5378846131153218 0.5378844601987274 -7.488102152231058e-07 -0.015727909910023815 +0.1044 0.5379190350504716 0.5379188939180433 -7.422683953595133e-07 -0.015742724940851004 +0.1045 0.5379534531879223 0.5379533237356421 -7.356280745107746e-07 -0.015757539263127725 +0.10460000000000001 0.5379878675277656 0.5379877496499699 -7.288900731872161e-07 -0.015772352876221113 +0.1047 0.538022278070087 0.5380221716594791 -7.220552259989965e-07 -0.015787165779498444 +0.10480000000000002 0.5380566848149655 0.538056589762629 -7.151243811842622e-07 -0.015801977972327092 +0.10490000000000001 0.5380910877624742 0.5380910039578861 -7.080984006091473e-07 -0.01581678945407456 +0.105 0.5381254869126796 0.5381254142437242 -7.009781594347064e-07 -0.01583160022410848 +0.10510000000000001 0.5381598822656417 0.538159820618624 -6.93764546449982e-07 -0.015846410281796623 +0.1052 0.5381942738214143 0.5381942230810739 -6.864584635724036e-07 -0.01586121962650687 +0.1053 0.5382286615800441 0.5382286216295697 -6.790608260975883e-07 -0.015876028257607266 +0.10540000000000001 0.538263045541571 0.538263016262615 -6.715725620887181e-07 -0.01589083617446593 +0.1055 0.5382974257060282 0.5382974069787207 -6.639946127651175e-07 -0.015905643376451135 +0.10560000000000001 0.5383318020734418 0.538331793776406 -6.563279322246984e-07 -0.015920449862931285 +0.1057 0.5383661746438305 0.5383661766541978 -6.485734871386484e-07 -0.0159352556332749 +0.1058 0.5384005434172061 0.5384005556106312 -6.407322569457197e-07 -0.01595006068685065 +0.10590000000000001 0.538434908393573 0.5384349306442492 -6.328052334081402e-07 -0.01596486502302731 +0.106 0.5384692695729276 0.5384693017536031 -6.247934206671246e-07 -0.015979668641173766 +0.10610000000000001 0.5385036269552594 0.5385036689372527 -6.166978354371633e-07 -0.015994471540659052 +0.1062 0.53853798054055 0.5385380321937665 -6.085195060623327e-07 -0.016009273720852354 +0.1063 0.5385723303287729 0.5385723915217211 -6.002594731269184e-07 -0.016024075181122945 +0.10640000000000001 0.5386066763198942 0.538606746919702 -5.919187889558142e-07 -0.016038875920840235 +0.1065 0.5386410185138719 0.5386410983863036 -5.83498517836567e-07 -0.016053675939373787 +0.10660000000000001 0.5386753569106557 0.5386754459201291 -5.749997352422209e-07 -0.01606847523609327 +0.1067 0.5387096915101872 0.5387097895197903 -5.664235284141839e-07 -0.016083273810368483 +0.1068 0.5387440223123999 0.5387441291839089 -5.577709960014055e-07 -0.016098071661569353 +0.10690000000000001 0.5387783493172187 0.5387784649111149 -5.490432475607765e-07 -0.01611286878906594 +0.107 0.5388126725245602 0.5388127967000483 -5.40241403751418e-07 -0.016127665192228437 +0.10710000000000001 0.5388469919343322 0.5388471245493581 -5.313665963069258e-07 -0.01614246087042714 +0.1072 0.5388813075464342 0.5388814484577027 -5.224199674802588e-07 -0.016157255823032516 +0.1073 0.5389156193607565 0.5389157684237498 -5.134026704323169e-07 -0.016172050049415115 +0.10740000000000001 0.5389499273771808 0.5389500844461775 -5.043158686490745e-07 -0.016186843548945645 +0.1075 0.5389842315955802 0.5389843965236731 -4.951607357750465e-07 -0.016201636320994944 +0.10760000000000002 0.5390185320158181 0.5390187046549336 -4.859384557798219e-07 -0.01621642836493396 +0.1077 0.5390528286377492 0.5390530088386664 -4.766502227637748e-07 -0.016231219680133798 +0.1078 0.5390871214612191 0.5390873090735886 -4.672972404584641e-07 -0.016246010265965644 +0.10790000000000001 0.5391214104860638 0.5391216053584273 -4.578807225041892e-07 -0.016260800121800884 +0.108 0.5391556957121101 0.5391558976919202 -4.484018920614119e-07 -0.016275589247010974 +0.1081 0.5391899771391754 0.5391901860728148 -4.388619816164674e-07 -0.01629037764096752 +0.1082 0.5392242547670674 0.5392244704998688 -4.292622330925866e-07 -0.016305165303042247 +0.10830000000000001 0.5392585285955843 0.5392587509718507 -4.1960389726702907e-07 -0.01631995223260705 +0.10840000000000001 0.5392927986245147 0.5392930274875395 -4.0988823379883854e-07 -0.016334738429033897 +0.1085 0.5393270648536374 0.5393273000457245 -4.0011651156190986e-07 -0.016349523891694914 +0.1086 0.539361327282721 0.5393615686452058 -3.9029000750701037e-07 -0.016364308619962364 +0.1087 0.5393955859115246 0.5393958332847942 -3.804100073556693e-07 -0.016379092613208635 +0.10880000000000001 0.5394298407397973 0.5394300939633112 -3.7047780490628845e-07 -0.016393875870806224 +0.10890000000000001 0.5394640917672779 0.5394643506795893 -3.6049470213128654e-07 -0.016408658392127795 +0.109 0.5394983389936953 0.5394986034324719 -3.504620090383215e-07 -0.016423440176546122 +0.1091 0.5395325824187678 0.5395328522208134 -3.403810432539567e-07 -0.016438221223434097 +0.1092 0.5395668220422039 0.5395670970434793 -3.302531300236611e-07 -0.016453001532164776 +0.10930000000000001 0.5396010578637014 0.5396013378993462 -3.2007960204527564e-07 -0.016467781102111313 +0.10940000000000001 0.5396352898829481 0.5396355747873017 -3.098617992053354e-07 -0.01648255993264701 +0.1095 0.5396695180996205 0.5396698077062453 -2.996010686068251e-07 -0.0164973380231453 +0.1096 0.5397037425133858 0.539704036655087 -2.8929876409733435e-07 -0.016512115372979735 +0.1097 0.5397379631238998 0.5397382616327491 -2.7895624631069094e-07 -0.016526891981524024 +0.10980000000000001 0.5397721799308074 0.5397724826381644 -2.685748823894052e-07 -0.016541667848151972 +0.10990000000000001 0.5398063929337434 0.539806699670278 -2.5815604579038087e-07 -0.01655644297223754 +0.11 0.5398406021323316 0.5398409127280461 -2.477011162571596e-07 -0.01657121735315482 +0.1101 0.539874807526185 0.5398751218104368 -2.3721147948685406e-07 -0.016585990990278014 +0.1102 0.5399090091149057 0.5399093269164297 -2.266885269774921e-07 -0.016600763882981484 +0.11030000000000001 0.5399432068980847 0.5399435280450164 -2.161336558476057e-07 -0.016615536030639717 +0.11040000000000001 0.5399774008753021 0.5399777251951999 -2.0554826869745302e-07 -0.016630307432627302 +0.1105 0.5400115910461272 0.5400119183659954 -1.9493377338697382e-07 -0.016645078088319006 +0.1106 0.5400457774101179 0.5400461075564298 -1.8429158279986702e-07 -0.016659847997089697 +0.1107 0.5400799599668215 0.540080292765542 -1.7362311478114067e-07 -0.016674617158314392 +0.11080000000000001 0.5401141387157733 0.5401144739923827 -1.6292979183180067e-07 -0.01668938557136822 +0.11090000000000001 0.5401483136564978 0.5401486512360149 -1.5221304097701172e-07 -0.01670415323562646 +0.111 0.5401824847885086 0.5401828244955134 -1.4147429355099161e-07 -0.016718920150464518 +0.1111 0.5402166521113072 0.5402169937699651 -1.3071498505129453e-07 -0.016733686315257925 +0.11120000000000001 0.5402508156243845 0.5402511590584694 -1.199365548543163e-07 -0.016748451729382365 +0.11130000000000001 0.5402849753272198 0.5402853203601379 -1.0914044615978336e-07 -0.01676321639221364 +0.1114 0.5403191312192805 0.5403194776740937 -9.832810567850236e-08 -0.01677798030312767 +0.1115 0.5403532833000235 0.5403536309994729 -8.750098348317414e-08 -0.01679274346150055 +0.1116 0.5403874315688934 0.5403877803354233 -7.666053283492125e-08 -0.016807505866708466 +0.11170000000000001 0.5404215760253236 0.5404219256811058 -6.580820994389613e-08 -0.016822267518127754 +0.11180000000000001 0.5404557166687358 0.5404560670356928 -5.494547382009496e-08 -0.01683702841513489 +0.1119 0.5404898534985405 0.5404902043983696 -4.407378605131296e-08 -0.01685178855710648 +0.112 0.5405239865141364 0.5405243377683338 -3.319461059844708e-08 -0.01686654794341925 +0.1121 0.5405581157149102 0.5405584671447949 -2.230941362896255e-08 -0.016881306573450074 +0.11220000000000001 0.5405922411002373 0.540592592526976 -1.1419663293980864e-08 -0.016896064446575952 +0.11230000000000001 0.5406263626694817 0.5406267139141115 -5.268295348581642e-10 -0.016910821562174022 +0.1124 0.5406604804219954 0.540660831305449 1.0367616110236455e-08 -0.016925577919621557 +0.1125 0.540694594357119 0.5406949447002483 2.1262200699742606e-08 -0.01694033351829597 +0.1126 0.5407287044741806 0.5407290540977815 3.215545010468168e-08 -0.016955088357574786 +0.11270000000000001 0.5407628107724974 0.540763159497334 4.304588918993546e-08 -0.01696984243683568 +0.11280000000000001 0.5407969132513745 0.5407972608982032 5.3932042030219174e-08 -0.01698459575545647 +0.1129 0.5408310119101052 0.540831358299699 6.481243209482956e-08 -0.016999348312815087 +0.113 0.5408651067479711 0.5408654517011441 7.568558245754642e-08 -0.017014100108289614 +0.1131 0.5408991977642421 0.5408995411018737 8.655001600826884e-08 -0.017028851141258253 +0.11320000000000001 0.540933284958176 0.5409336265012357 9.740425563342647e-08 -0.017043601411099365 +0.11330000000000001 0.5409673683290195 0.5409677078985902 1.0824682439292133e-07 -0.01705835091719141 +0.1134 0.5410014478760067 0.5410017852933106 1.1907624582890852e-07 -0.017073099658913012 +0.1135 0.5410355235983604 0.5410358586847823 1.298910440317158e-07 -0.017087847635642934 +0.1136 0.5410695954952915 0.5410699280724036 1.406897439173993e-07 -0.017102594846760046 +0.11370000000000001 0.5411036635659988 0.5411039934555852 1.5147087141509363e-07 -0.017117341291643363 +0.11380000000000001 0.5411377278096701 0.5411380548337503 1.622329536404843e-07 -0.01713208696967205 +0.1139 0.5411717882254803 0.5411721122063353 1.7297451922193563e-07 -0.017146831880225394 +0.114 0.5412058448125937 0.5412061655727884 1.836940982657964e-07 -0.017161576022682833 +0.11410000000000001 0.541239897570162 0.5412402149325711 1.943902228074279e-07 -0.017176319396423917 +0.1142 0.5412739464973254 0.5412742602851567 2.0506142683895945e-07 -0.01719106200082834 +0.11430000000000001 0.5413079915932124 0.5413083016300316 2.157062466284776e-07 -0.017205803835275948 +0.1144 0.5413420328569394 0.5413423389666948 2.2632322088655954e-07 -0.017220544899146695 +0.1145 0.5413760702876117 0.5413763722946574 2.369108908217843e-07 -0.0172352851918207 +0.11460000000000001 0.5414101038843223 0.5414104016134433 2.474678006542108e-07 -0.017250024712678193 +0.1147 0.5414441336461528 0.5414444269225891 2.5799249747660014e-07 -0.017264763461099557 +0.11480000000000001 0.5414781595721737 0.5414784482216434 2.684835316985046e-07 -0.017279501436465308 +0.1149 0.5415121816614427 0.5415124655101674 2.789394571017789e-07 -0.01729423863815609 +0.115 0.5415461999130066 0.5415464787877348 2.8935883115976946e-07 -0.017308975065552696 +0.11510000000000001 0.5415802143259003 0.5415804880539317 2.997402151483364e-07 -0.01732371071803603 +0.1152 0.5416142248991478 0.5416144933083566 3.100821744095317e-07 -0.01733844559498718 +0.11530000000000001 0.5416482316317605 0.5416484945506204 3.203832785458882e-07 -0.017353179695787313 +0.1154 0.5416822345227391 0.541682491780346 3.3064210139266415e-07 -0.01736791301981778 +0.1155 0.5417162335710727 0.5417164849971688 3.4085722162846555e-07 -0.01738264556646005 +0.11560000000000001 0.5417502287757385 0.5417504742007369 3.510272226919797e-07 -0.01739737733509573 +0.1157 0.5417842201357028 0.5417844593907097 3.6115069307340875e-07 -0.01741210832510655 +0.11580000000000001 0.5418182076499201 0.5418184405667594 3.7122622642549175e-07 -0.017426838535874397 +0.1159 0.541852191317334 0.5418524177285704 3.8125242185493846e-07 -0.0174415679667813 +0.116 0.5418861711368766 0.5418863908758387 3.9122788403345155e-07 -0.0174562966172094 +0.11610000000000001 0.5419201471074689 0.5419203600082729 4.011512235169157e-07 -0.017471024486541004 +0.1162 0.5419541192280204 0.5419543251255933 4.110210569396866e-07 -0.017485751574158537 +0.11630000000000001 0.5419880874974293 0.5419882862275323 4.2083600707010227e-07 -0.017500477879444566 +0.1164 0.542022051914583 0.5420222433138342 4.305947029492607e-07 -0.01751520340178179 +0.1165 0.5420560124783583 0.542056196384255 4.402957803628649e-07 -0.017529928140553076 +0.11660000000000001 0.54208996918762 0.5420901454385629 4.4993788178571137e-07 -0.01754465209514139 +0.1167 0.5421239220412225 0.5421240904765375 4.595196567702686e-07 -0.01755937526492984 +0.11680000000000001 0.5421578710380093 0.5421580314979705 4.69039762002188e-07 -0.017574097649301717 +0.1169 0.5421918161768127 0.542191968502665 4.784968613835705e-07 -0.017588819247640403 +0.117 0.5422257574564544 0.5422259014904357 4.878896265325672e-07 -0.017603540059329428 +0.11710000000000001 0.5422596948757454 0.542259830461109 4.972167367556235e-07 -0.01761826008375246 +0.1172 0.542293628433486 0.5422937554145228 5.064768792140129e-07 -0.01763297932029332 +0.11730000000000002 0.5423275581284661 0.5423276763505265 5.156687492291478e-07 -0.017647697768335968 +0.1174 0.5423614839594643 0.5423615932689803 5.247910505046249e-07 -0.017662415427264475 +0.1175 0.5423954059252496 0.5423955061697564 5.338424951262244e-07 -0.017677132296463085 +0.11760000000000001 0.5424293240245798 0.5424294150527381 5.428218038117105e-07 -0.017691848375316163 +0.1177 0.5424632382562027 0.5424633199178197 5.517277062438986e-07 -0.01770656366320821 +0.11780000000000002 0.5424971486188558 0.5424972207649067 5.605589409041212e-07 -0.017721278159523856 +0.1179 0.5425310551112665 0.5425311175939157 5.693142557106068e-07 -0.017735991863647924 +0.118 0.5425649577321517 0.542565010404774 5.779924079907239e-07 -0.017750704774965313 +0.11810000000000001 0.5425988564802187 0.5425988991974202 5.865921645087369e-07 -0.0177654168928611 +0.1182 0.542632751354164 0.5426327839718033 5.951123017433613e-07 -0.017780128216720474 +0.11830000000000002 0.5426666423526753 0.5426666647278833 6.035516062485868e-07 -0.017794838745928788 +0.1184 0.5427005294744291 0.5427005414656308 6.119088746259216e-07 -0.017809548479871536 +0.1185 0.5427344127180933 0.5427344141850271 6.201829135799031e-07 -0.01782425741793432 +0.11860000000000001 0.5427682920823256 0.542768282886064 6.283725406119878e-07 -0.017838965559502918 +0.1187 0.5428021675657739 0.5428021475687435 6.364765832989061e-07 -0.017853672903963235 +0.11880000000000002 0.5428360391670769 0.5428360082330776 6.444938806249301e-07 -0.017868379450701286 +0.1189 0.5428699068848639 0.5428698648790897 6.524232821769615e-07 -0.017883085199103272 +0.119 0.5429037707177545 0.5429037175068124 6.602636485886215e-07 -0.017897790148555522 +0.11910000000000001 0.5429376306643593 0.5429375661162886 6.680138520953616e-07 -0.0179124942984445 +0.1192 0.5429714867232797 0.5429714107075713 6.756727761736414e-07 -0.017927197648156798 +0.11930000000000002 0.5430053388931078 0.5430052512807233 6.832393160127737e-07 -0.01794190019707918 +0.1194 0.5430391871724269 0.5430390878358173 6.907123782651237e-07 -0.01795660194459851 +0.1195 0.5430730315598117 0.5430729203729355 6.980908820453102e-07 -0.017971302890101824 +0.11960000000000001 0.5431068720538272 0.5431067488921701 7.053737582363162e-07 -0.01798600303297629 +0.1197 0.5431407086530309 0.5431405733936225 7.125599499890889e-07 -0.01800070237260921 +0.11980000000000002 0.5431745413559704 0.5431743938774035 7.196484130278513e-07 -0.01801540090838805 +0.1199 0.5432083701611861 0.5432082103436335 7.266381154835688e-07 -0.01803009863970041 +0.12 0.5432421950672086 0.5432420227924417 7.335280383657938e-07 -0.01804479556593396 +0.12010000000000001 0.5432760160725616 0.5432758312239669 7.403171752295989e-07 -0.018059491686476647 +0.1202 0.5433098331757594 0.5433096356383567 7.470045330082442e-07 -0.01807418700071643 +0.12030000000000002 0.543343646375309 0.5433434360357674 7.535891317078658e-07 -0.018088881508041523 +0.12040000000000001 0.5433774556697091 0.5433772324163644 7.600700046572761e-07 -0.018103575207840172 +0.1205 0.5434112610574502 0.5434110247803219 7.66446198507964e-07 -0.01811826809950084 +0.12060000000000001 0.5434450625370156 0.5434448131278222 7.727167736781837e-07 -0.01813296018241209 +0.1207 0.5434788601068806 0.5434785974590566 7.788808044084661e-07 -0.01814765145596267 +0.1208 0.5435126537655133 0.5435123777742246 7.849373785395741e-07 -0.018162341919541466 +0.12090000000000001 0.5435464435113737 0.5435461540735338 7.908855980676144e-07 -0.018177031572537444 +0.121 0.5435802293429148 0.5435799263572 7.967245793105704e-07 -0.018191720414339748 +0.12110000000000001 0.5436140112585826 0.5436136946254472 8.024534525197247e-07 -0.01820640844433768 +0.1212 0.5436477892568157 0.5436474588785073 8.080713627123259e-07 -0.018221095661920695 +0.1213 0.5436815633360457 0.5436812191166196 8.135774693385223e-07 -0.018235782066478346 +0.12140000000000001 0.5437153334946977 0.5437149753400318 8.189709465034056e-07 -0.01825046765740036 +0.1215 0.5437490997311896 0.5437487275489986 8.242509831335454e-07 -0.018265152434076604 +0.12160000000000001 0.5437828620439331 0.5437824757437822 8.294167831435217e-07 -0.018279836395897087 +0.1217 0.5438166204313328 0.5438162199246526 8.34467565546948e-07 -0.018294519542251992 +0.1218 0.5438503748917873 0.5438499600918859 8.394025645119818e-07 -0.018309201872531496 +0.12190000000000001 0.5438841254236892 0.5438836962457667 8.44221029361325e-07 -0.01832388338612616 +0.122 0.5439178720254244 0.5439174283865857 8.489222247942685e-07 -0.01833856408242652 +0.12210000000000001 0.543951614695373 0.5439511565146404 8.535054314418034e-07 -0.018353243960823263 +0.1222 0.5439853534319095 0.5439848806302356 8.579699451449763e-07 -0.0183679230207073 +0.1223 0.544019088233402 0.5440186007336818 8.623150775100008e-07 -0.018382601261469612 +0.12240000000000001 0.5440528190982137 0.5440523168252966 8.66540156463369e-07 -0.01839727868250135 +0.1225 0.5440865460247015 0.5440860289054038 8.706445254746953e-07 -0.01841195528319381 +0.12260000000000001 0.544120269011218 0.5441197369743334 8.746275444448948e-07 -0.01842663106293846 +0.1227 0.5441539880561095 0.544153441032421 8.784885890400496e-07 -0.01844130602112684 +0.1228 0.5441877031577174 0.5441871410800088 8.822270514130537e-07 -0.01845598015715069 +0.12290000000000001 0.5442214143143786 0.5442208371174446 8.858423400370796e-07 -0.01847065347040187 +0.123 0.5442551215244251 0.5442545291450817 8.893338798721118e-07 -0.01848532596027244 +0.12310000000000001 0.5442888247861837 0.5442882171632787 8.927011123649464e-07 -0.018499997626154525 +0.1232 0.5443225240979771 0.5443219011724001 8.959434960598145e-07 -0.018514668467440414 +0.1233 0.5443562194581233 0.5443555811728157 8.990605057657142e-07 -0.018529338483522607 +0.12340000000000001 0.544389910864936 0.5443892571648996 9.020516331670336e-07 -0.018544007673793644 +0.1235 0.5444235983167248 0.5444229291490318 9.049163871011068e-07 -0.01855867603764629 +0.12360000000000002 0.5444572818117955 0.5444565971255966 9.076542930586129e-07 -0.01857334357447343 +0.1237 0.5444909613484494 0.5444902610949831 9.102648939607327e-07 -0.018588010283668074 +0.12380000000000001 0.544524636924985 0.544523921057585 9.127477498815928e-07 -0.018602676164623407 +0.12390000000000001 0.5445583085396961 0.5445575770138003 9.151024378817318e-07 -0.01861734121673272 +0.124 0.5445919761908737 0.5445912289640316 9.173285524521901e-07 -0.018632005439389483 +0.1241 0.5446256398768056 0.5446248769086854 9.194257055700206e-07 -0.018646668831987314 +0.1242 0.544659299595776 0.5446585208481723 9.213935265317552e-07 -0.018661331393919962 +0.12430000000000001 0.5446929553460663 0.5446921607829066 9.232316620089165e-07 -0.018675993124581316 +0.12440000000000001 0.5447266071259549 0.5447257967133062 9.249397766031286e-07 -0.018690654023365418 +0.1245 0.5447602549337177 0.544759428639793 9.265175522910063e-07 -0.018705314089666466 +0.1246 0.5447938987676278 0.544793056562792 9.279646889237547e-07 -0.018719973322878797 +0.1247 0.544827538625956 0.5448266804827315 9.292809040051253e-07 -0.01873463172239691 +0.12480000000000001 0.5448611745069702 0.5448603004000427 9.30465932857949e-07 -0.018749289287615375 +0.12490000000000001 0.5448948064089372 0.5448939163151604 9.315195286796474e-07 -0.018763946017929013 +0.125 0.5449284343301208 0.5449275282285215 9.32441462597744e-07 -0.018778601912732715 +0.12510000000000002 0.5449620582687835 0.544961136140566 9.332315237253752e-07 -0.018793256971421524 +0.1252 0.5449956782231857 0.5449947400517364 9.338895191612906e-07 -0.018807911193390675 +0.12530000000000002 0.5450292941915869 0.5450283399624773 9.344152741008749e-07 -0.01882256457803552 +0.1254 0.5450629061722445 0.5450619358732363 9.348086317251258e-07 -0.018837217124751584 +0.1255 0.5450965141634148 0.5450955277844618 9.350694533671877e-07 -0.018851868832934483 +0.12560000000000002 0.5451301181633531 0.5451291156966053 9.351976189009292e-07 -0.018866519701980045 +0.1257 0.5451637181703137 0.5451626996101195 9.35193025797254e-07 -0.018881169731284165 +0.12580000000000002 0.5451973141825501 0.545196279525459 9.350555898457458e-07 -0.018895818920242974 +0.1259 0.5452309061983152 0.54522985544308 9.347852452656902e-07 -0.018910467268252684 +0.126 0.5452644942158611 0.5452634273634394 9.343819448726087e-07 -0.018925114774709696 +0.12610000000000002 0.54529807823344 0.5452969952869957 9.33845659134569e-07 -0.018939761439010522 +0.1262 0.5453316582493033 0.5453305592142086 9.331763773934298e-07 -0.01895440726055185 +0.12630000000000002 0.5453652342617029 0.5453641191455381 9.323741070321745e-07 -0.01896905223873048 +0.1264 0.5453988062688908 0.5453976750814458 9.314388739745105e-07 -0.01898369637294342 +0.1265 0.5454323742691187 0.5454312270223929 9.303707222407809e-07 -0.01899833966258778 +0.12660000000000002 0.545465938260639 0.5454647749688417 9.291697142255195e-07 -0.019012982107060806 +0.1267 0.5454994982417047 0.5454983189212544 9.278359313080742e-07 -0.019027623705759913 +0.12680000000000002 0.5455330542105699 0.5455318588800936 9.263694724093163e-07 -0.019042264458082683 +0.1269 0.5455666061654886 0.5455653948458217 9.247704555459535e-07 -0.01905690436342682 +0.127 0.5456001541047164 0.5455989268189005 9.230390165537727e-07 -0.019071543421190124 +0.12710000000000002 0.5456336980265104 0.5456324547997924 9.211753100313302e-07 -0.0190861816307707 +0.1272 0.5456672379291284 0.5456659787889585 9.191795089513732e-07 -0.019100818991566668 +0.12730000000000002 0.5457007738108299 0.5456994987868593 9.1705180466084e-07 -0.01911545550297627 +0.1274 0.545734305669876 0.5457330147939548 9.147924063812596e-07 -0.01913009116439797 +0.1275 0.54576783350453 0.5457665268107041 9.124015424299969e-07 -0.019144725975230432 +0.12760000000000002 0.5458013573130563 0.5458000348375649 9.098794590545189e-07 -0.019159359934872375 +0.1277 0.5458348770937222 0.5458335388749934 9.072264209319947e-07 -0.019173993042722638 +0.12780000000000002 0.5458683928447967 0.545867038923445 9.044427108362285e-07 -0.019188625298180315 +0.1279 0.5459019045645515 0.5459005349833733 9.01528629970727e-07 -0.0192032567006446 +0.128 0.5459354122512605 0.54593402705523 8.984844980242102e-07 -0.01921788724951481 +0.1281 0.5459689159032011 0.545967515139465 8.953106522824328e-07 -0.01923251694419046 +0.1282 0.5460024155186523 0.5460009992365259 8.920074489604524e-07 -0.01924714578407116 +0.12830000000000003 0.546035911095897 0.5460344793468589 8.885752619258724e-07 -0.019261773768556725 +0.12840000000000001 0.5460694026332213 0.546067955470907 8.850144833094653e-07 -0.01927640089704706 +0.1285 0.5461028901289142 0.5461014276091113 8.813255233386386e-07 -0.01929102716894225 +0.1286 0.5461363735812683 0.5461348957619098 8.775088100598794e-07 -0.019305652583642592 +0.1287 0.5461698529885799 0.5461683599297379 8.735647900048882e-07 -0.01932027714054843 +0.1288 0.5462033283491491 0.5462018201130284 8.694939270803559e-07 -0.01933490083906029 +0.12890000000000001 0.5462367996612796 0.5462352763122104 8.65296703789209e-07 -0.019349523678578867 +0.129 0.5462702669232793 0.5462687285277099 8.609736197318085e-07 -0.01936414565850496 +0.1291 0.5463037301334605 0.5463021767599497 8.56525192993729e-07 -0.019378766778239593 +0.1292 0.5463371892901399 0.5463356210093491 8.519519587024682e-07 -0.019393387037183876 +0.1293 0.5463706443916384 0.5463690612763237 8.472544701931817e-07 -0.019408006434739108 +0.12940000000000002 0.5464040954362821 0.5464024975612849 8.424332981760152e-07 -0.019422624970306692 +0.1295 0.5464375424224013 0.5464359298646403 8.374890310136607e-07 -0.01943724264328822 +0.1296 0.5464709853483314 0.5464693581867935 8.324222746103338e-07 -0.019451859453085463 +0.1297 0.5465044242124131 0.5465027825281439 8.272336521897294e-07 -0.01946647539910029 +0.1298 0.5465378590129925 0.5465362028890861 8.219238042395105e-07 -0.01948109048073471 +0.12990000000000002 0.5465712897484205 0.5465696192700102 8.164933886223302e-07 -0.01949570469739094 +0.13 0.5466047164170542 0.5466030316713022 8.109430804648099e-07 -0.01951031804847127 +0.1301 0.546638139017256 0.5466364400933419 8.05273571879983e-07 -0.019524930533378233 +0.1302 0.5466715575473943 0.5466698445365052 7.994855720228067e-07 -0.01953954215151443 +0.1303 0.5467049720058436 0.5467032450011629 7.935798070901612e-07 -0.01955415290228268 +0.13040000000000002 0.546738382390984 0.5467366414876793 7.875570200988058e-07 -0.01956876278508589 +0.1305 0.5467717887012027 0.5467700339964147 7.814179711074232e-07 -0.01958337179932719 +0.1306 0.5468051909348925 0.546803422527723 7.75163436328441e-07 -0.019597979944409767 +0.1307 0.5468385890904532 0.5468368070819524 7.68794208905188e-07 -0.01961258721973705 +0.1308 0.5468719831662914 0.5468701876594455 7.623110984122938e-07 -0.019627193624712592 +0.13090000000000002 0.5469053731608199 0.5469035642605387 7.557149309111999e-07 -0.019641799158740054 +0.131 0.5469387590724593 0.5469369368855623 7.490065486726039e-07 -0.019656403821223307 +0.1311 0.5469721408996366 0.5469703055348402 7.421868099544149e-07 -0.019671007611566316 +0.1312 0.5470055186407867 0.54700367020869 7.352565896678875e-07 -0.01968561052917326 +0.1313 0.5470388922943514 0.5470370309074227 7.282167781563764e-07 -0.019700212573448447 +0.13140000000000002 0.54707226185878 0.5470703876313425 7.210682816949365e-07 -0.019714813743796283 +0.1315 0.54710562733253 0.5471037403807469 7.138120227401235e-07 -0.019729414039621414 +0.1316 0.5471389887140661 0.5471370891559266 7.064489388475259e-07 -0.019744013460328613 +0.1317 0.5471723460018612 0.5471704339571647 6.98979983504433e-07 -0.01975861200532275 +0.1318 0.5472056991943963 0.5472037747847374 6.91406125297167e-07 -0.019773209674008897 +0.13190000000000002 0.5472390482901603 0.5472371116389136 6.83728348327417e-07 -0.019787806465792278 +0.132 0.5472723932876509 0.5472704445199544 6.759476519069274e-07 -0.01980240238007825 +0.1321 0.5473057341853735 0.5473037734281134 6.680650503076979e-07 -0.019816997416272318 +0.1322 0.5473390709818432 0.5473370983636368 6.600815724844278e-07 -0.01983159157378019 +0.1323 0.5473724036755826 0.5473704193267622 6.519982623520715e-07 -0.01984618485200766 +0.13240000000000002 0.547405732265124 0.5474037363177198 6.438161784250163e-07 -0.0198607772503607 +0.1325 0.5474390567490083 0.5474370493367312 6.355363938448377e-07 -0.019875368768245454 +0.1326 0.5474723771257853 0.5474703583840104 6.271599960472329e-07 -0.019889959405068207 +0.1327 0.5475056933940146 0.5475036634597621 6.186880866787536e-07 -0.019904549160235367 +0.1328 0.5475390055522644 0.5475369645641833 6.101217815135396e-07 -0.019919138033153556 +0.13290000000000002 0.5475723135991131 0.5475702616974623 6.01462210092496e-07 -0.019933726023229514 +0.133 0.5476056175331482 0.5476035548597779 5.927105161118718e-07 -0.019948313129870117 +0.1331 0.5476389173529668 0.5476368440513006 5.838678565628364e-07 -0.01996289935248242 +0.1332 0.5476722130571761 0.5476701292721922 5.749354023421027e-07 -0.019977484690473633 +0.1333 0.5477055046443929 0.5477034105226046 5.659143371972153e-07 -0.019992069143251096 +0.13340000000000002 0.5477387921132447 0.5477366878026814 5.568058583649282e-07 -0.020006652710222332 +0.1335 0.5477720754623685 0.547769961112556 5.476111762381386e-07 -0.020021235390794995 +0.1336 0.5478053546904116 0.547803230452353 5.383315138107747e-07 -0.020035817184376897 +0.1337 0.547838629796032 0.547836495822187 5.289681069275964e-07 -0.020050398090376006 +0.1338 0.5478719007778979 0.5478697572221635 5.195222040899061e-07 -0.020064978108200477 +0.13390000000000002 0.5479051676346884 0.5479030146523773 5.099950661224817e-07 -0.020079557237258554 +0.134 0.5479384303650933 0.5479362681129145 5.003879659792876e-07 -0.02009413547695869 +0.1341 0.5479716889678125 0.5479695176038503 4.907021887712304e-07 -0.020108712826709448 +0.1342 0.5480049434415576 0.54800276312525 4.809390315163586e-07 -0.0201232892859196 +0.1343 0.5480381937850509 0.548036004677169 4.7109980302884047e-07 -0.020137864853998006 +0.13440000000000002 0.5480714399970261 0.5480692422596519 4.6118582361365235e-07 -0.02015243953035374 +0.1345 0.5481046820762279 0.5481024758727335 4.5119842484453443e-07 -0.02016701331439601 +0.1346 0.5481379200214122 0.5481357055164378 4.411389496472573e-07 -0.02018158620553416 +0.13470000000000001 0.5481711538313464 0.5481689311907779 4.3100875180002163e-07 -0.020196158203177703 +0.1348 0.5482043835048097 0.5482021528957568 4.2080919612774714e-07 -0.020210729306736324 +0.1349 0.5482376090405925 0.5482353706313665 4.1054165811349463e-07 -0.020225299515619834 +0.135 0.5482708304374971 0.548268584397588 4.0020752362091017e-07 -0.020239868829238238 +0.1351 0.5483040476943377 0.5483017941943913 3.898081887554472e-07 -0.020254437247001628 +0.13520000000000001 0.5483372608099402 0.5483350000217354 3.793450598643666e-07 -0.02026900476832033 +0.1353 0.5483704697831424 0.5483682018795683 3.688195530648919e-07 -0.02028357139260477 +0.1354 0.5484036746127944 0.5484013997678263 3.58233094382987e-07 -0.020298137119265553 +0.1355 0.5484368752977582 0.5484345936864352 3.475871192260005e-07 -0.02031270194771343 +0.1356 0.5484700718369084 0.5484677836353085 3.3688307249368776e-07 -0.020327265877359318 +0.13570000000000002 0.5485032642291315 0.5485009696143487 3.261224080786107e-07 -0.020341828907614285 +0.1358 0.5485364524733268 0.5485341516234465 3.1530658893552665e-07 -0.02035639103788955 +0.1359 0.5485696365684056 0.5485673296624813 3.044370867483215e-07 -0.020370952267596477 +0.136 0.5486028165132922 0.5486005037313203 2.935153818189873e-07 -0.020385512596146623 +0.1361 0.5486359923069233 0.5486336738298191 2.8254296274843327e-07 -0.020400072022951653 +0.13620000000000002 0.5486691639482483 0.5486668399578216 2.7152132631158565e-07 -0.020414630547423433 +0.1363 0.5487023314362295 0.5487000021151597 2.604519771937097e-07 -0.020429188168973968 +0.1364 0.548735494769842 0.5487331603016529 2.49336427976532e-07 -0.020443744887015405 +0.1365 0.5487686539480736 0.5487663145171093 2.3817619858312877e-07 -0.02045830070096007 +0.1366 0.5488018089699255 0.5487994647613242 2.269728163889484e-07 -0.020472855610220428 +0.13670000000000002 0.5488349598344116 0.548832611034081 2.157278159303777e-07 -0.02048740961420911 +0.1368 0.5488681065405592 0.5488657533351502 2.0444273866881968e-07 -0.020501962712338898 +0.1369 0.5489012490874084 0.5488988916642908 1.931191327408932e-07 -0.02051651490402273 +0.137 0.5489343874740129 0.5489320260212492 1.8175855273638852e-07 -0.020531066188673716 +0.1371 0.5489675216994399 0.5489651564057588 1.7036255967051162e-07 -0.0205456165657051 +0.13720000000000002 0.5490006517627691 0.548998282817541 1.5893272053979501e-07 -0.020560166034530303 +0.1373 0.5490337776630944 0.5490314052563042 1.474706081971977e-07 -0.02057471459456288 +0.1374 0.5490668993995227 0.5490645237217446 1.3597780119944947e-07 -0.02058926224521657 +0.1375 0.5491000169711749 0.5490976382135456 1.2445588348786174e-07 -0.02060380898590526 +0.1376 0.5491331303771851 0.5491307487313773 1.1290644427036645e-07 -0.020618354816042978 +0.13770000000000002 0.549166239616701 0.5491638552748977 1.0133107766069349e-07 -0.02063289973504393 +0.1378 0.5491993446888844 0.5491969578437519 8.973138263673741e-08 -0.020647443742322483 +0.1379 0.5492324455929103 0.5492300564375714 7.810896267973488e-08 -0.020661986837293127 +0.138 0.5492655423279674 0.5492631510559757 6.646542562854796e-08 -0.020676529019370546 +0.1381 0.5492986348932587 0.5492962416985705 5.4802383443741665e-08 -0.020691070287969557 +0.13820000000000002 0.549331723288001 0.5493293283649492 4.312145195778383e-08 -0.020705610642505166 +0.1383 0.5493648075114245 0.5493624110546917 3.142425067034771e-08 -0.02072015008239251 +0.1384 0.5493978875627737 0.5493954897673651 1.9712402533206275e-08 -0.020734688607046886 +0.1385 0.5494309634413068 0.5494285645025232 7.987533686554249e-09 -0.02074922621588376 +0.1386 0.5494640351462962 0.5494616352597065 -3.748726697117011e-09 -0.020763762908318745 +0.13870000000000002 0.549497102677028 0.5494947020384428 -1.5494746714861396e-08 -0.020778298683767626 +0.1388 0.5495301660328027 0.5495277648382462 -2.724889189460733e-08 -0.020792833541646336 +0.1389 0.5495632252129344 0.5495608236586177 -3.900952548051978e-08 -0.02080736748137095 +0.139 0.5495962802167519 0.5495938784990452 -5.07750086155799e-08 -0.020821900502357747 +0.1391 0.5496293310435976 0.5496269293590031 -6.25437005976736e-08 -0.02083643260402312 +0.13920000000000002 0.5496623776928282 0.5496599762379527 -7.431395909144461e-08 -0.020850963785783654 +0.1393 0.5496954201638147 0.549693019135342 -8.608414036812007e-08 -0.020865494047056066 +0.1394 0.5497284584559421 0.5497260580506053 -9.785259953189185e-08 -0.02088002338725724 +0.1395 0.5497614925686094 0.549759092983164 -1.096176907508517e-07 -0.020894551805804237 +0.1396 0.5497945225012301 0.5497921239324263 -1.21377767489661e-07 -0.02090907930211425 +0.13970000000000002 0.5498275482532317 0.5498251508977858 -1.3313118272725855e-07 -0.020923605875604642 +0.1398 0.5498605698240562 0.5498581738786242 -1.448762892118649e-07 -0.020938131525692946 +0.1399 0.5498935872131594 0.5498911928743089 -1.5661143966394508e-07 -0.020952656251796833 +0.14 0.5499266004200116 0.5499242078841945 -1.6833498703988647e-07 -0.02096718005333415 +0.1401 0.5499596094440974 0.5499572189076213 -1.8004528474363513e-07 -0.020981702929722904 +0.14020000000000002 0.5499926142849153 0.5499902259439172 -1.9174068684180146e-07 -0.020996224880381262 +0.1403 0.5500256149419784 0.5500232289923964 -2.0341954833080766e-07 -0.021010745904727523 +0.1404 0.5500586114148137 0.5500562280523593 -2.1508022536587124e-07 -0.021025266002180184 +0.1405 0.5500916037029626 0.550089223123093 -2.2672107544835507e-07 -0.021039785172157866 +0.1406 0.5501245918059807 0.5501222142038716 -2.3834045773107881e-07 -0.021054303414079392 +0.14070000000000002 0.5501575757234379 0.5501552012939558 -2.4993673316403564e-07 -0.021068820727363716 +0.1408 0.5501905554549182 0.5501881843925923 -2.6150826482052025e-07 -0.021083337111429956 +0.1409 0.5502235310000196 0.5502211634990152 -2.7305341805672345e-07 -0.021097852565697385 +0.141 0.5502565023583547 0.5502541386124447 -2.845705607545934e-07 -0.021112367089585454 +0.1411 0.5502894695295496 0.5502871097320879 -2.9605806360633036e-07 -0.021126880682513744 +0.14120000000000002 0.5503224325132453 0.5503200768571388 -3.075143002601033e-07 -0.021141393343902044 +0.1413 0.5503553913090965 0.5503530399867778 -3.1893764763923915e-07 -0.021155905073170254 +0.1414 0.5503883459167719 0.5503859991201718 -3.3032648610875626e-07 -0.021170415869738463 +0.1415 0.5504212963359546 0.5504189542564752 -3.4167919973904226e-07 -0.021184925733026924 +0.1416 0.5504542425663415 0.5504519053948289 -3.52994176514021e-07 -0.021199434662456027 +0.14170000000000002 0.5504871846076435 0.5504848525343603 -3.642698085809526e-07 -0.021213942657446354 +0.1418 0.5505201224595857 0.5505177956741836 -3.7550449254186713e-07 -0.02122844971741861 +0.1419 0.5505530561219067 0.5505507348134 -3.866966294674423e-07 -0.021242955841793684 +0.142 0.5505859855943598 0.5505836699510979 -3.978446254382373e-07 -0.021257461029992625 +0.1421 0.5506189108767114 0.5506166010863524 -4.089468914753036e-07 -0.02127196528143664 +0.14220000000000002 0.5506518319687422 0.5506495282182257 -4.2000184398427454e-07 -0.02128646859554711 +0.1423 0.5506847488702463 0.5506824513457667 -4.3100790490802066e-07 -0.021300970971745534 +0.1424 0.5507176615810323 0.5507153704680119 -4.4196350185155e-07 -0.02131547240945364 +0.1425 0.5507505701009218 0.5507482855839845 -4.5286706852609715e-07 -0.02132997290809326 +0.1426 0.5507834744297503 0.5507811966926947 -4.6371704487402354e-07 -0.021344472467086418 +0.14270000000000002 0.5508163745673671 0.5508141037931402 -4.7451187709657283e-07 -0.021358971085855282 +0.1428 0.5508492705136351 0.5508470068843062 -4.852500180840824e-07 -0.02137346876382221 +0.1429 0.5508821622684303 0.5508799059651646 -4.959299277629281e-07 -0.021387965500409695 +0.143 0.5509150498316427 0.5509128010346749 -5.065500731649131e-07 -0.02140246129504039 +0.1431 0.5509479332031753 0.5509456920917842 -5.17108928482779e-07 -0.02141695614713712 +0.14320000000000002 0.5509808123829447 0.5509785791354266 -5.276049755142953e-07 -0.02143145005612287 +0.1433 0.5510136873708809 0.5510114621645242 -5.380367038287925e-07 -0.021445943021420784 +0.1434 0.5510465581669266 0.5510443411779866 -5.484026111002294e-07 -0.021460435042454193 +0.1435 0.5510794247710387 0.5510772161747108 -5.587012031349481e-07 -0.021474926118646556 +0.1436 0.5511122871831862 0.5511100871535816 -5.68930994176986e-07 -0.02148941624942151 +0.14370000000000002 0.5511451454033517 0.5511429541134717 -5.790905069635865e-07 -0.021503905434202858 +0.1438 0.5511779994315307 0.5511758170532415 -5.891782733913331e-07 -0.021518393672414548 +0.1439 0.5512108492677312 0.5512086759717394 -5.991928340998154e-07 -0.021532880963480702 +0.144 0.551243694911975 0.5512415308678016 -6.091327392765411e-07 -0.02154736730682562 +0.1441 0.5512765363642957 0.5512743817402527 -6.189965485181581e-07 -0.021561852701873736 +0.14420000000000002 0.5513093736247401 0.551307228587905 -6.287828309969878e-07 -0.02157633714804967 +0.1443 0.5513422066933676 0.5513400714095595 -6.384901660994036e-07 -0.0215908206447782 +0.1444 0.5513750355702499 0.5513729102040051 -6.481171430094967e-07 -0.021605303191484262 +0.1445 0.5514078602554714 0.5514057449700192 -6.576623614584776e-07 -0.021619784787592952 +0.1446 0.5514406807491286 0.5514385757063677 -6.671244316969194e-07 -0.021634265432529533 +0.14470000000000002 0.5514734970513303 0.5514714024118048 -6.765019746612921e-07 -0.021648745125719418 +0.1448 0.551506309162198 0.5515042250850738 -6.857936222237626e-07 -0.021663223866588206 +0.1449 0.551539117081865 0.5515370437249061 -6.94998017608528e-07 -0.021677701654561662 +0.145 0.5515719208104766 0.5515698583300225 -7.041138152252824e-07 -0.02169217848906571 +0.1451 0.5516047203481899 0.551602668899132 -7.131396810855506e-07 -0.02170665436952642 +0.14520000000000002 0.5516375156951742 0.5516354754309336 -7.22074292802688e-07 -0.02172112929537004 +0.1453 0.5516703068516101 0.5516682779241142 -7.309163401192365e-07 -0.021735603266022953 +0.1454 0.5517030938176902 0.5517010763773506 -7.396645248514133e-07 -0.021750076280911745 +0.1455 0.5517358765936189 0.5517338707893086 -7.483175613332005e-07 -0.021764548339463164 +0.1456 0.5517686551796115 0.5517666611586438 -7.568741761110331e-07 -0.021779019441104108 +0.14570000000000002 0.5518014295758945 0.5517994474840009 -7.653331086654447e-07 -0.021793489585261644 +0.1458 0.5518341997827063 0.5518322297640137 -7.736931113000445e-07 -0.021807958771362965 +0.1459 0.5518669658002963 0.5518650079973068 -7.819529494190736e-07 -0.021822426998835506 +0.146 0.5518997276289246 0.5518977821824937 -7.901114019159827e-07 -0.021836894267106815 +0.1461 0.5519324852688627 0.5519305523181782 -7.981672608403656e-07 -0.021851360575604595 +0.14620000000000002 0.5519652387203924 0.5519633184029541 -8.061193320640925e-07 -0.02186582592375676 +0.1463 0.5519979879838065 0.551996080435405 -8.13966435170288e-07 -0.021880290310991337 +0.1464 0.5520307330594086 0.5520288384141052 -8.217074039529315e-07 -0.021894753736736564 +0.1465 0.5520634739475124 0.5520615923376186 -8.293410861115458e-07 -0.021909216200420776 +0.1466 0.5520962106484422 0.5520943422045006 -8.368663439450863e-07 -0.02192367770147259 +0.14670000000000002 0.5521289431625325 0.5521270880132962 -8.442820541854079e-07 -0.021938138239320656 +0.1468 0.5521616714901276 0.5521598297625417 -8.515871081637982e-07 -0.021952597813393846 +0.1469 0.5521943956315826 0.552192567450764 -8.587804123660892e-07 -0.021967056423121217 +0.147 0.5522271155872618 0.5522253010764809 -8.658608880995899e-07 -0.021981514067932008 +0.14709999999999998 0.5522598313575395 0.5522580306382014 -8.728274717983986e-07 -0.021995970747255563 +0.14720000000000003 0.5522925429427997 0.5522907561344256 -8.796791154952466e-07 -0.022010426460521388 +0.14730000000000001 0.5523252503434357 0.5523234775636449 -8.864147865161875e-07 -0.022024881207159203 +0.1474 0.5523579535598503 0.552356194924342 -8.930334681744867e-07 -0.02203933498659888 +0.1475 0.5523906525924558 0.5523889082149916 -8.995341594375539e-07 -0.022053787798270465 +0.14759999999999998 0.5524233474416734 0.5524216174340597 -9.059158750379659e-07 -0.022068239641604134 +0.14770000000000003 0.5524560381079333 0.5524543225800043 -9.121776462506226e-07 -0.02208269051603027 +0.14780000000000001 0.5524887245916745 0.5524870236512753 -9.183185205041688e-07 -0.022097140420979378 +0.1479 0.5525214068933452 0.5525197206463147 -9.24337561547528e-07 -0.02211158935588218 +0.148 0.5525540850134014 0.5525524135635564 -9.302338500050134e-07 -0.022126037320169517 +0.14809999999999998 0.5525867589523082 0.5525851024014274 -9.360064829877501e-07 -0.02214048431327241 +0.14820000000000003 0.5526194287105388 0.5526177871583466 -9.416545744822535e-07 -0.02215493033462206 +0.14830000000000002 0.5526520942885744 0.5526504678327262 -9.471772558500291e-07 -0.022169375383649832 +0.1484 0.5526847556869047 0.5526831444229701 -9.525736752724612e-07 -0.022183819459787257 +0.1485 0.552717412906027 0.5527158169274761 -9.578429980838798e-07 -0.022198262562466015 +0.14859999999999998 0.5527500659464464 0.5527484853446347 -9.629844073821836e-07 -0.022212704691117982 +0.14870000000000003 0.5527827148086754 0.5527811496728299 -9.679971036957724e-07 -0.02222714584517517 +0.14880000000000002 0.5528153594932343 0.5528138099104387 -9.72880305427637e-07 -0.022241586024069768 +0.1489 0.5528480000006508 0.5528464660558314 -9.776332484667805e-07 -0.022256025227234147 +0.149 0.5528806363314592 0.5528791181073727 -9.822551867433305e-07 -0.022270463454100817 +0.14909999999999998 0.5529132684862013 0.5529117660634206 -9.867453922285385e-07 -0.022284900704102453 +0.14920000000000003 0.5529458964654257 0.5529444099223269 -9.911031551013139e-07 -0.022299336976671937 +0.14930000000000002 0.5529785202696879 0.5529770496824379 -9.95327784025779e-07 -0.022313772271242288 +0.1494 0.5530111398995494 0.553009685342094 -9.994186056516696e-07 -0.02232820658724673 +0.1495 0.5530437553555787 0.5530423168996302 -1.0033749652249568e-06 -0.02234263992411859 +0.14959999999999998 0.5530763666383502 0.5530749443533759 -1.0071962269209145e-06 -0.022357072281291402 +0.14970000000000003 0.5531089737484449 0.5531075677016548 -1.0108817732334963e-06 -0.02237150365819887 +0.14980000000000002 0.5531415766864489 0.5531401869427862 -1.0144310060300477e-06 -0.022385934054274827 +0.1499 0.5531741754529549 0.5531728020750839 -1.0178433456631275e-06 -0.022400363468953324 +0.15 0.5532067700485611 0.5532054130968573 -1.0211182312480638e-06 -0.022414791901668576 +0.15009999999999998 0.553239360473871 0.5532380200064109 -1.024255121551132e-06 -0.02242921935185493 +0.15020000000000003 0.553271946729493 0.5532706228020446 -1.0272534944899547e-06 -0.02244364581894692 +0.15030000000000002 0.5533045288160414 0.5533032214820544 -1.0301128469669685e-06 -0.022458071302379236 +0.1504 0.5533371067341353 0.5533358160447316 -1.0328326953690237e-06 -0.02247249580158675 +0.1505 0.5533696804843984 0.5533684064883637 -1.035412576011474e-06 -0.022486919316004512 +0.15059999999999998 0.5534022500674594 0.5534009928112344 -1.0378520442499983e-06 -0.022501341845067687 +0.15070000000000003 0.5534348154839512 0.5534335750116242 -1.0401506748136669e-06 -0.022515763388211707 +0.15080000000000002 0.5534673767345113 0.553466153087809 -1.0423080630261872e-06 -0.022530183944872086 +0.1509 0.5534999338197811 0.553498727038062 -1.0443238231960805e-06 -0.02254460351448448 +0.151 0.5535324867404067 0.5535312968606535 -1.0461975900599718e-06 -0.022559022096484894 +0.15109999999999998 0.5535650354970367 0.55356386255385 -1.0479290177833889e-06 -0.022573439690309234 +0.15120000000000003 0.5535975800903248 0.553596424115916 -1.0495177807934297e-06 -0.02258785629539379 +0.15130000000000002 0.5536301205209273 0.5536289815451125 -1.050963573556718e-06 -0.02260227191117492 +0.1514 0.5536626567895048 0.5536615348396986 -1.0522661103018471e-06 -0.02261668653708919 +0.1515 0.5536951888967199 0.5536940839979307 -1.0534251260185812e-06 -0.0226311001725733 +0.15159999999999998 0.5537277168432391 0.5537266290180634 -1.0544403754031428e-06 -0.022645512817064173 +0.15170000000000003 0.5537602406297311 0.5537591698983486 -1.0553116336908808e-06 -0.022659924469998833 +0.15180000000000002 0.5537927602568679 0.553791706637037 -1.0560386963787138e-06 -0.02267433513081453 +0.1519 0.5538252757253236 0.5538242392323774 -1.0566213792251311e-06 -0.022688744798948675 +0.152 0.5538577870357746 0.553856767682617 -1.0570595184722364e-06 -0.022703153473838777 +0.15209999999999999 0.5538902941888999 0.5538892919860019 -1.0573529707347262e-06 -0.022717561154922628 +0.15220000000000003 0.55392279718538 0.5539218121407768 -1.0575016131109116e-06 -0.022731967841638098 +0.15230000000000002 0.553955296025897 0.5539543281451857 -1.0575053435712967e-06 -0.022746373533423254 +0.1524 0.5539877907111355 0.5539868399974716 -1.0573640799593775e-06 -0.022760778229716335 +0.1525 0.5540202812417809 0.5540193476958766 -1.0570777612128879e-06 -0.02277518192995577 +0.15259999999999999 0.5540527676185205 0.554051851238643 -1.0566463468086873e-06 -0.02278958463358018 +0.15270000000000003 0.5540852498420418 0.5540843506240123 -1.056069816596228e-06 -0.022803986340028243 +0.15280000000000002 0.554117727913034 0.5541168458502259 -1.0553481711861323e-06 -0.022818387048738925 +0.1529 0.5541502018321867 0.5541493369155256 -1.0544814318946827e-06 -0.022832786759151298 +0.153 0.5541826716001901 0.5541818238181531 -1.0534696407438204e-06 -0.02284718547070462 +0.15309999999999999 0.5542151372177351 0.5542143065563505 -1.0523128603501242e-06 -0.022861583182838315 +0.15320000000000003 0.5542475986855128 0.5542467851283608 -1.0510111740358319e-06 -0.022875979894992023 +0.15330000000000002 0.554280056004214 0.5542792595324275 -1.0495646857733298e-06 -0.022890375606605475 +0.1534 0.55431250917453 0.5543117297667951 -1.0479735204071972e-06 -0.022904770317118614 +0.1535 0.5543449581971515 0.5543441958297091 -1.0462378231546055e-06 -0.022919164025971574 +0.15360000000000001 0.5543774030727682 0.5543766577194164 -1.044357759993897e-06 -0.0229335567326046 +0.1537 0.5544098438020701 0.5544091154341653 -1.0423335178866289e-06 -0.02294794843645819 +0.15380000000000002 0.5544422803857463 0.554441568972206 -1.04016530411144e-06 -0.02296233913697296 +0.1539 0.5544747128244842 0.55447401833179 -1.0378533468746731e-06 -0.02297672883358967 +0.154 0.5545071411189704 0.5545064635111712 -1.0353978948107745e-06 -0.022991117525749297 +0.15410000000000001 0.5545395652698907 0.5545389045086053 -1.0327992171488276e-06 -0.023005505212892987 +0.1542 0.5545719852779286 0.5545713413223506 -1.0300576038790865e-06 -0.023019891894462047 +0.15430000000000002 0.5546044011437665 0.5546037739506682 -1.0271733655864423e-06 -0.02303427756989795 +0.1544 0.5546368128680845 0.554636202391821 -1.0241468335614456e-06 -0.023048662238642333 +0.1545 0.5546692204515612 0.5546686266440757 -1.0209783588011057e-06 -0.02306304590013704 +0.15460000000000002 0.5547016238948724 0.5547010467057015 -1.0176683135076914e-06 -0.023077428553824005 +0.1547 0.5547340231986921 0.5547334625749709 -1.0142170902005532e-06 -0.023091810199145458 +0.15480000000000002 0.5547664183636912 0.5547658742501597 -1.010625101827145e-06 -0.023106190835543657 +0.1549 0.554798809390538 0.5547982817295473 -1.0068927816520024e-06 -0.023120570462461132 +0.155 0.5548311962798986 0.5548306850114171 -1.003020582979186e-06 -0.023134949079340595 +0.15510000000000002 0.5548635790324352 0.5548630840940562 -9.990089798739277e-07 -0.023149326685624895 +0.1552 0.554895957648807 0.5548954789757555 -9.948584662744508e-07 -0.02316370328075698 +0.15530000000000002 0.55492833212967 0.5549278696548106 -9.905695563805494e-07 -0.023178078864180097 +0.1554 0.5549607024756763 0.5549602561295213 -9.861427843205206e-07 -0.023192453435337598 +0.1555 0.5549930686874743 0.5549926383981919 -9.815787044842317e-07 -0.02320682699367298 +0.15560000000000002 0.555025430765709 0.5550250164591315 -9.768778912455645e-07 -0.023221199538629996 +0.1557 0.5550577887110205 0.5550573903106544 -9.720409387403706e-07 -0.023235571069652496 +0.15580000000000002 0.5550901425240451 0.5550897599510795 -9.67068461033005e-07 -0.02324994158618455 +0.1559 0.5551224922054147 0.5551221253787315 -9.619610917277477e-07 -0.023264311087670388 +0.156 0.5551548377557561 0.55515448659194 -9.567194844684046e-07 -0.023278679573554346 +0.15610000000000002 0.555187179175692 0.5551868435890408 -9.513443124387067e-07 -0.023293047043281043 +0.1562 0.5552195164658399 0.555219196368375 -9.458362681402654e-07 -0.023307413496295195 +0.15630000000000002 0.5552518496268121 0.55525154492829 -9.401960637256401e-07 -0.023321778932041744 +0.1564 0.5552841786592154 0.5552838892671386 -9.344244305542482e-07 -0.023336143349965713 +0.1565 0.5553165035636517 0.5553162293832808 -9.2852211941441e-07 -0.023350506749512435 +0.15660000000000002 0.5553488243407169 0.5553485652750827 -9.22489900190282e-07 -0.023364869130127267 +0.1567 0.5553811409910012 0.5553808969409166 -9.163285617508343e-07 -0.023379230491255842 +0.15680000000000002 0.5554134535150889 0.5554132243791621 -9.100389121718955e-07 -0.023393590832343908 +0.1569 0.5554457619135582 0.5554455475882054 -9.036217783475742e-07 -0.023407950152837448 +0.157 0.555478066186981 0.5554778665664399 -8.970780059347483e-07 -0.023422308452182572 +0.15710000000000002 0.5555103663359229 0.5555101813122665 -8.90408459075509e-07 -0.02343666572982553 +0.1572 0.5555426623609429 0.555542491824093 -8.836140204526721e-07 -0.02345102198521284 +0.15730000000000002 0.555574954262593 0.5555747981003353 -8.76695591733867e-07 -0.023465377217791124 +0.1574 0.5556072420414186 0.5556071001394165 -8.69654092516825e-07 -0.023479731427007183 +0.1575 0.555639525697958 0.555639397939768 -8.62490460606935e-07 -0.023494084612308022 +0.15760000000000002 0.5556718052327421 0.5556716914998292 -8.552056521005102e-07 -0.02350843677314078 +0.1577 0.5557040806462947 0.5557039808180478 -8.478006407741656e-07 -0.023522787908952826 +0.15780000000000002 0.5557363519391318 0.5557362658928793 -8.402764184178846e-07 -0.023537138019191616 +0.1579 0.5557686191117619 0.5557685467227882 -8.326339946962413e-07 -0.02355148710330486 +0.158 0.5558008821646855 0.5558008233062475 -8.248743966488004e-07 -0.0235658351607404 +0.15810000000000002 0.5558331410983953 0.5558330956417392 -8.169986686901165e-07 -0.023580182190946257 +0.1582 0.5558653959133759 0.5558653637277542 -8.090078730538242e-07 -0.023594528193370663 +0.15830000000000002 0.5558976466101033 0.5558976275627924 -8.009030885436363e-07 -0.023608873167461977 +0.1584 0.5559298931890452 0.5559298871453628 -7.926854113937676e-07 -0.023623217112668717 +0.1585 0.5559621356506609 0.5559621424739845 -7.843559546583112e-07 -0.023637560028439645 +0.15860000000000002 0.5559943739954009 0.5559943935471852 -7.759158479336836e-07 -0.02365190191422363 +0.1587 0.5560266082237066 0.5560266403635032 -7.673662376084245e-07 -0.023666242769469763 +0.15880000000000002 0.5560588383360108 0.556058882921486 -7.5870828677993e-07 -0.02368058259362727 +0.1589 0.5560910643327368 0.5560911212196914 -7.499431743107632e-07 -0.02369492138614558 +0.159 0.5561232862142984 0.5561233552566872 -7.41072095494788e-07 -0.023709259146474287 +0.15910000000000002 0.5561555039811007 0.5561555850310518 -7.320962614743021e-07 -0.023723595874063155 +0.1592 0.5561877176335387 0.5561878105413736 -7.230168993788144e-07 -0.023737931568362146 +0.15930000000000002 0.5562199271719978 0.5562200317862516 -7.138352519087121e-07 -0.023752266228821373 +0.15940000000000001 0.5562521325968532 0.5562522487642957 -7.045525771687267e-07 -0.023766599854891112 +0.1595 0.5562843339084705 0.5562844614741265 -6.951701487512008e-07 -0.023780932446021825 +0.15960000000000002 0.5563165311072054 0.5563166699143756 -6.856892552642435e-07 -0.023795264001664183 +0.1597 0.5563487241934026 0.5563488740836855 -6.761112002762193e-07 -0.023809594521268983 +0.1598 0.5563809131673972 0.5563810739807105 -6.664373022047254e-07 -0.023823924004287223 +0.15990000000000001 0.5564130980295133 0.5564132696041154 -6.566688942333254e-07 -0.023838252450170083 +0.16 0.5564452787800647 0.5564454609525771 -6.468073236731708e-07 -0.023852579858368896 +0.16010000000000002 0.5564774554193538 0.5564776480247838 -6.36853952240557e-07 -0.02386690622833515 +0.1602 0.5565096279476727 0.5565098308194355 -6.268101557238559e-07 -0.02388123155952057 +0.1603 0.5565417963653022 0.5565420093352441 -6.166773238724943e-07 -0.02389555585137701 +0.16040000000000001 0.5565739606725124 0.5565741835709335 -6.06456859897353e-07 -0.023909879103356537 +0.1605 0.5566061208695617 0.5566063535252396 -5.961501808315894e-07 -0.023924201314911353 +0.16060000000000002 0.5566382769566971 0.5566385191969104 -5.85758716864504e-07 -0.023938522485493854 +0.1607 0.5566704289341544 0.5566706805847066 -5.752839111750063e-07 -0.02395284261455661 +0.1608 0.5567025768021575 0.5567028376874008 -5.647272200703934e-07 -0.023967161701552372 +0.16090000000000002 0.5567347205609189 0.5567349905037787 -5.540901124589936e-07 -0.02398147974593405 +0.161 0.5567668602106388 0.5567671390326384 -5.433740697668998e-07 -0.023995796747154755 +0.16110000000000002 0.5567989957515058 0.5567992832727905 -5.325805857436805e-07 -0.024010112704667755 +0.1612 0.5568311271836969 0.5568314232230591 -5.217111662680907e-07 -0.024024427617926516 +0.1613 0.5568632545073757 0.556863558882281 -5.107673290427606e-07 -0.024038741486384657 +0.16140000000000002 0.5568953777226947 0.5568956902493059 -4.997506035109289e-07 -0.024053054309495947 +0.1615 0.5569274968297933 0.5569278173229969 -4.886625306621539e-07 -0.024067366086714406 +0.16160000000000002 0.5569596118287988 0.5569599401022305 -4.775046626159796e-07 -0.02408167681749418 +0.1617 0.5569917227198259 0.5569920585858964 -4.662785626219357e-07 -0.02409598650128959 +0.1618 0.5570238295029765 0.5570241727728978 -4.54985804726471e-07 -0.02411029513755515 +0.16190000000000002 0.5570559321783398 0.5570562826621518 -4.436279735786641e-07 -0.024124602725745542 +0.162 0.5570880307459921 0.5570883882525888 -4.322066643330791e-07 -0.02413890926531563 +0.16210000000000002 0.557120125205997 0.5571204895431531 -4.2072348217792044e-07 -0.024153214755720444 +0.1622 0.5571522155584046 0.5571525865328031 -4.0918004221013327e-07 -0.02416751919641521 +0.1623 0.5571843018032524 0.5571846792205111 -3.9757796943540313e-07 -0.02418182258685532 +0.16240000000000002 0.5572163839405639 0.5572167676052628 -3.859188981991668e-07 -0.02419612492649633 +0.1625 0.5572484619703504 0.5572488516860592 -3.7420447220049e-07 -0.02421042621479399 +0.16260000000000002 0.5572805358926088 0.5572809314619147 -3.624363441590006e-07 -0.024224726451204236 +0.1627 0.557312605707323 0.5573130069318581 -3.506161755234549e-07 -0.024239025635183153 +0.1628 0.5573446714144632 0.557345078094933 -3.387456363884711e-07 -0.02425332376618702 +0.16290000000000002 0.557376733013986 0.5573771449501971 -3.2682640523085116e-07 -0.02426762084367229 +0.163 0.5574087905058346 0.5574092074967223 -3.1486016849324727e-07 -0.024281916867095594 +0.16310000000000002 0.5574408438899381 0.5574412657335959 -3.0284862055640627e-07 -0.024296211835913743 +0.1632 0.5574728931662116 0.557473319659919 -2.9079346344773604e-07 -0.024310505749583714 +0.1633 0.5575049383345567 0.5575053692748084 -2.7869640653599426e-07 -0.02432479860756269 +0.16340000000000002 0.5575369793948606 0.5575374145773951 -2.665591664063882e-07 -0.024339090409307998 +0.1635 0.5575690163469966 0.5575694555668252 -2.543834664858746e-07 -0.02435338115427715 +0.16360000000000002 0.5576010491908244 0.5576014922422597 -2.4217103682111496e-07 -0.02436767084192787 +0.1637 0.5576330779261889 0.5576335246028745 -2.2992361392581984e-07 -0.02438195947171801 +0.1638 0.5576651025529207 0.5576655526478604 -2.17642940517071e-07 -0.024396247043105626 +0.16390000000000002 0.5576971230708364 0.557697576376424 -2.0533076516143778e-07 -0.024410533555548956 +0.164 0.5577291394797383 0.5577295957877866 -1.9298884214313805e-07 -0.0244248190085064 +0.16410000000000002 0.5577611517794142 0.5577616108811845 -1.8061893116566585e-07 -0.024439103401436554 +0.1642 0.5577931599696373 0.5577936216558698 -1.6822279708811338e-07 -0.02445338673379815 +0.1643 0.5578251640501666 0.5578256281111097 -1.5580220966843195e-07 -0.024467669005050183 +0.16440000000000002 0.5578571640207463 0.5578576302461865 -1.433589433830207e-07 -0.024481950214651743 +0.1645 0.5578891598811059 0.5578896280603987 -1.3089477712835418e-07 -0.02449623036206213 +0.16460000000000002 0.5579211516309608 0.5579216215530592 -1.1841149391567107e-07 -0.024510509446740828 +0.1647 0.5579531392700111 0.5579536107234977 -1.0591088071831845e-07 -0.024524787468147492 +0.1648 0.5579851227979425 0.5579855955710584 -9.339472810745986e-08 -0.02453906442574197 +0.16490000000000002 0.558017102214426 0.5580175760951012 -8.086483008901135e-08 -0.02455334031898425 +0.165 0.5580490775191179 0.558049552295002 -6.832298380179957e-08 -0.02456761514733454 +0.16510000000000002 0.5580810487116592 0.5580815241701521 -5.577098926429214e-08 -0.02458188891025321 +0.1652 0.5581130157916767 0.5581134917199587 -4.3210649117858546e-08 -0.024596161607200823 +0.1653 0.5581449787587817 0.5581454549438446 -3.06437683821742e-08 -0.024610433237638087 +0.16540000000000002 0.5581769376125709 0.5581774138412482 -1.8072154159883697e-08 -0.024624703801025924 +0.1655 0.5582088923526262 0.5582093684116237 -5.497615418242549e-09 -0.024638973296825406 +0.16560000000000002 0.5582408429785143 0.5582413186544413 7.078037296028017e-09 -0.02465324172449782 +0.16570000000000001 0.558272789489787 0.5582732645691866 1.9652992113913803e-08 -0.024667509083504596 +0.1658 0.5583047318859817 0.5583052061553614 3.222543609737727e-08 -0.024681775373307378 +0.1659 0.5583366701666196 0.558337143412483 4.479355550715547e-08 -0.024696040593367944 +0.166 0.5583686043312078 0.5583690763400847 5.735553607055799e-08 -0.024710304743148302 +0.16610000000000003 0.5584005343792388 0.5584010049377157 6.990956322519559e-08 -0.024724567822110615 +0.16620000000000001 0.5584324603101886 0.5584329292049411 8.245382242602628e-08 -0.0247388298297172 +0.1663 0.5584643821235196 0.5584648491413418 9.498649932923597e-08 -0.024753090765430613 +0.1664 0.5584962998186783 0.558496764746514 1.0750578013224432e-07 -0.02476735062871354 +0.1665 0.5585282133950966 0.5585286760200707 1.2000985180615764e-07 -0.024781609419028846 +0.16660000000000003 0.5585601228521915 0.5585605829616401 1.324969023386302e-07 -0.02479586713583963 +0.16670000000000001 0.5585920281893645 0.5585924855708666 1.4496512099754222e-07 -0.024810123778609125 +0.1668 0.558623929406002 0.5586243838474104 1.574126987161084e-07 -0.024824379346800717 +0.1669 0.5586558265014763 0.5586562777909473 1.6983782814838921e-07 -0.024838633839878055 +0.167 0.5586877194751436 0.5586881674011691 1.8223870407868548e-07 -0.024852887257304897 +0.16710000000000003 0.5587196083263459 0.5587200526777836 1.946135236366442e-07 -0.024867139598545217 +0.16720000000000002 0.5587514930544095 0.558751933620514 2.0696048659563093e-07 -0.024881390863063135 +0.1673 0.5587833736586465 0.5587838102290998 2.1927779560171334e-07 -0.024895641050323002 +0.1674 0.5588152501383538 0.5588156825032957 2.31563656444278e-07 -0.024909890159789297 +0.1675 0.5588471224928132 0.5588475504428725 2.438162782503195e-07 -0.02492413819092672 +0.16760000000000003 0.5588789907212918 0.5588794140476168 2.5603387389383503e-07 -0.02493838514320014 +0.16770000000000002 0.5589108548230418 0.5589112733173306 2.682146601484803e-07 -0.024952631016074596 +0.1678 0.5589427147973003 0.5589431282518318 2.8035685803451393e-07 -0.024966875809015302 +0.1679 0.5589745706432901 0.5589749788509537 2.9245869294369786e-07 -0.02498111952148768 +0.168 0.5590064223602189 0.5590068251145455 3.0451839501399736e-07 -0.0249953621529573 +0.16810000000000003 0.5590382699472799 0.5590386670424717 3.165341992961146e-07 -0.025009603702889946 +0.16820000000000002 0.5590701134036511 0.5590705046346127 3.285043462253334e-07 -0.025023844170751583 +0.1683 0.5591019527284964 0.5591023378908637 3.404270816631527e-07 -0.0250380835560083 +0.1684 0.5591337879209648 0.5591341668111361 3.52300657119331e-07 -0.025052321858126444 +0.1685 0.5591656189801909 0.5591659913953564 3.64123330237609e-07 -0.0250665590765725 +0.16860000000000003 0.5591974459052943 0.5591978116434664 3.758933648650986e-07 -0.025080795210813134 +0.16870000000000002 0.5592292686953806 0.5592296275554233 3.876090314269831e-07 -0.025095030260315204 +0.1688 0.5592610873495409 0.5592614391311994 3.992686070930507e-07 -0.025109264224545732 +0.1689 0.559292901866852 0.5592932463707825 4.108703760691279e-07 -0.02512349710297195 +0.169 0.559324712246376 0.5593250492741751 4.2241262987463557e-07 -0.025137728895061263 +0.16910000000000003 0.5593565184871611 0.5593568478413954 4.338936675507554e-07 -0.025151959600281243 +0.16920000000000002 0.5593883205882412 0.5593886420724762 4.453117959102304e-07 -0.025166189218099662 +0.1693 0.5594201185486359 0.5594204319674655 4.566653299120649e-07 -0.025180417747984452 +0.1694 0.559451912367351 0.5594522175264258 4.679525926476469e-07 -0.025194645189403737 +0.1695 0.5594837020433783 0.5594839987494351 4.791719159513708e-07 -0.025208871541825852 +0.16960000000000003 0.5595154875756949 0.5595157756365855 4.903216402618593e-07 -0.025223096804719243 +0.16970000000000002 0.5595472689632655 0.5595475481879844 5.01400115260342e-07 -0.025237320977552626 +0.1698 0.5595790462050393 0.5595793164037531 5.124056997596327e-07 -0.02525154405979481 +0.1699 0.5596108192999532 0.5596110802840285 5.233367622314855e-07 -0.025265766050914875 +0.17 0.5596425882469296 0.559642839828961 5.341916808621061e-07 -0.025279986950382027 +0.17010000000000003 0.5596743530448776 0.559674595038716 5.449688438852185e-07 -0.025294206757665645 +0.17020000000000002 0.5597061136926929 0.5597063459134729 5.55666649776354e-07 -0.02530842547223533 +0.1703 0.5597378701892575 0.5597380924534254 5.662835075859185e-07 -0.02532264309356085 +0.1704 0.5597696225334402 0.5597698346587815 5.76817836994703e-07 -0.02533685962111214 +0.1705 0.5598013707240971 0.5598015725297633 5.872680687579734e-07 -0.02535107505435933 +0.17060000000000003 0.5598331147600701 0.5598333060666063 5.976326447609814e-07 -0.025365289392772734 +0.17070000000000002 0.5598648546401891 0.5598650352695607 6.07910018574076e-07 -0.025379502635822854 +0.1708 0.5598965903632702 0.5598967601388901 6.180986552029033e-07 -0.02539371478298036 +0.1709 0.5599283219281174 0.5599284806748718 6.281970317267849e-07 -0.02540792583371613 +0.171 0.5599600493335215 0.5599601968777966 6.382036372432065e-07 -0.0254221357875012 +0.17110000000000003 0.5599917725782604 0.5599919087479689 6.481169734784409e-07 -0.025436344643806775 +0.17120000000000002 0.5600234916610999 0.5600236162857066 6.57935554565503e-07 -0.02545055240210429 +0.1713 0.5600552065807931 0.5600553194913409 6.676579073494615e-07 -0.02546475906186532 +0.1714 0.5600869173360806 0.560087018365216 6.77282572081328e-07 -0.02547896462256164 +0.1715 0.5601186239256915 0.5601187129076892 6.86808101973968e-07 -0.025493169083665237 +0.17160000000000003 0.5601503263483415 0.5601504031191309 6.962330640070125e-07 -0.025507372444648225 +0.17170000000000002 0.5601820246027354 0.5601820889999245 7.055560387325688e-07 -0.025521574704982942 +0.1718 0.5602137186875654 0.5602137705504655 7.147756206360434e-07 -0.02553577586414187 +0.1719 0.5602454086015123 0.5602454477711629 7.23890418441453e-07 -0.025549975921597724 +0.172 0.5602770943432451 0.5602771206624378 7.328990550836689e-07 -0.025564174876823383 +0.17210000000000003 0.5603087759114213 0.5603087892247237 7.418001684023068e-07 -0.02557837272929192 +0.17220000000000002 0.5603404533046865 0.5603404534584663 7.505924105588591e-07 -0.02559256947847656 +0.1723 0.5603721265216757 0.5603721133641234 7.592744490914072e-07 -0.025606765123850708 +0.1724 0.5604037955610123 0.5604037689421651 7.678449664982878e-07 -0.025620959664888 +0.1725 0.5604354604213083 0.5604354201930732 7.7630266082096e-07 -0.025635153101062205 +0.17260000000000003 0.5604671211011655 0.5604670671173414 7.846462456440051e-07 -0.02564934543184734 +0.17270000000000002 0.5604987775991744 0.560498709715475 7.928744503726826e-07 -0.025663536656717546 +0.1728 0.5605304299139149 0.5605303479879907 8.009860203994634e-07 -0.02567772677514717 +0.1729 0.5605620780439564 0.5605619819354167 8.089797174370972e-07 -0.02569191578661072 +0.173 0.5605937219878578 0.5605936115582928 8.168543193798339e-07 -0.02570610369058296 +0.17310000000000003 0.5606253617441679 0.560625236857169 8.24608620775269e-07 -0.025720290486538757 +0.17320000000000002 0.560656997311425 0.560656857832607 8.322414332129213e-07 -0.02573447617395318 +0.1733 0.5606886286881579 0.5606884744851793 8.39751584685855e-07 -0.02574866075230153 +0.1734 0.5607202558728852 0.5607200868154688 8.471379206453911e-07 -0.025762844221059233 +0.1735 0.5607518788641156 0.5607516948240692 8.543993040843745e-07 -0.02577702657970192 +0.17360000000000003 0.5607834976603487 0.5607832985115844 8.615346149820624e-07 -0.02579120782770542 +0.17370000000000002 0.5608151122600747 0.5608148978786286 8.685427512755695e-07 -0.02580538796454578 +0.1738 0.5608467226617739 0.5608464929258261 8.754226288876232e-07 -0.025819566989699103 +0.1739 0.560878328863918 0.5608780836538114 8.821731815600309e-07 -0.02583374490264184 +0.174 0.5609099308649695 0.5609096700632286 8.887933612422572e-07 -0.025847921702850496 +0.17410000000000003 0.5609415286633825 0.5609412521547312 8.952821381469356e-07 -0.025862097389801875 +0.17420000000000002 0.5609731222576017 0.5609728299289829 9.016385011939576e-07 -0.025876271962972836 +0.1743 0.5610047116460638 0.5610044033866559 9.078614577884281e-07 -0.02589044542184057 +0.1744 0.5610362968271971 0.5610359725284323 9.139500345423102e-07 -0.025904617765882293 +0.1745 0.5610678777994216 0.5610675373550027 9.199032764972692e-07 -0.02591878899457556 +0.17460000000000003 0.5610994545611492 0.5610990978670671 9.25720248290407e-07 -0.025932959107397985 +0.17470000000000002 0.561131027110784 0.5611306540653337 9.314000338211947e-07 -0.025947128103827474 +0.1748 0.5611625954467223 0.5611622059505195 9.36941736195962e-07 -0.025961295983342014 +0.1749 0.5611941595673532 0.5611937535233498 9.423444781719859e-07 -0.025975462745419894 +0.175 0.5612257194710577 0.5612252967845582 9.476074023795356e-07 -0.025989628389539433 +0.17510000000000003 0.5612572751562105 0.5612568357348865 9.527296710998279e-07 -0.026003792915179326 +0.17520000000000002 0.5612888266211786 0.5612883703750841 9.577104668756498e-07 -0.026017956321818293 +0.1753 0.5613203738643222 0.5613199007059081 9.62548992344825e-07 -0.02603211860893532 +0.1754 0.5613519168839951 0.5613514267281235 9.672444704067473e-07 -0.02604627977600958 +0.1755 0.5613834556785438 0.561382948442502 9.717961440558476e-07 -0.026060439822520338 +0.17560000000000003 0.5614149902463094 0.5614144658498234 9.762032772697715e-07 -0.026074598747947198 +0.17570000000000002 0.561446520585626 0.5614459789508739 9.804651544542686e-07 -0.02608875655176983 +0.1758 0.5614780466948224 0.5614774877464466 9.845810808872812e-07 -0.026102913233468153 +0.1759 0.5615095685722211 0.5615089922373417 9.885503825524111e-07 -0.026117068792522236 +0.176 0.5615410862161389 0.5615404924243654 9.92372406694031e-07 -0.026131223228412378 +0.17610000000000003 0.5615725996248871 0.5615719883083308 9.960465214287062e-07 -0.026145376540618992 +0.17620000000000002 0.561604108796772 0.5616034798900561 9.995721163003068e-07 -0.026159528728622733 +0.1763 0.5616356137300949 0.5616349671703669 1.0029486017804068e-06 -0.02617367979190446 +0.1764 0.5616671144231511 0.5616664501500932 1.006175410378507e-06 -0.026187829729945124 +0.1765 0.5616986108742321 0.5616979288300714 1.0092519955873236e-06 -0.026201978542225963 +0.17660000000000003 0.5617301030816247 0.5617294032111435 1.0121778328819886e-06 -0.026216126228228366 +0.17670000000000002 0.5617615910436111 0.561760873294156 1.0149524192759607e-06 -0.02623027278743388 +0.1768 0.5617930747584694 0.561792339079961 1.0175752734875587e-06 -0.026244418219324307 +0.1769 0.5618245542244733 0.5618238005694152 1.020045936439562e-06 -0.026258562523381553 +0.177 0.5618560294398933 0.5618552577633802 1.0223639707040988e-06 -0.026272705699087767 +0.17710000000000004 0.5618875004029955 0.5618867106627219 1.0245289612242914e-06 -0.026286847745925258 +0.17720000000000002 0.5619189671120433 0.5619181592683107 1.0265405146481221e-06 -0.02630098866337653 +0.1773 0.561950429565296 0.5619496035810208 1.0283982603831454e-06 -0.026315128450924305 +0.1774 0.5619818877610104 0.5619810436017307 1.0301018497638204e-06 -0.026329267108051453 +0.1775 0.5620133416974403 0.5620124793313224 1.0316509561625331e-06 -0.026343404634241004 +0.17760000000000004 0.5620447913728364 0.5620439107706816 1.0330452760998199e-06 -0.02635754102897623 +0.17770000000000002 0.5620762367854475 0.5620753379206973 1.0342845279120993e-06 -0.026371676291740583 +0.1778 0.5621076779335196 0.5621067607822614 1.0353684528063845e-06 -0.026385810422017715 +0.1779 0.5621391148152965 0.5621381793562694 1.0362968145827267e-06 -0.026399943419291423 +0.178 0.5621705474290206 0.5621695936436191 1.0370693993566604e-06 -0.02641407528304573 +0.17810000000000004 0.562201975772932 0.5622010036452108 1.0376860163363588e-06 -0.0264282060127648 +0.17820000000000003 0.5622333998452691 0.5622324093619473 1.038146497045478e-06 -0.02644233560793298 +0.17830000000000001 0.5622648196442694 0.5622638107947342 1.0384506961558237e-06 -0.026456464068034896 +0.1784 0.5622962351681694 0.5622952079444782 1.0385984908212187e-06 -0.026470591392555278 +0.1785 0.5623276464152037 0.5623266008120882 1.038589780955057e-06 -0.02648471758097903 +0.17860000000000004 0.5623590533836071 0.5623579893984748 1.0384244897854167e-06 -0.026498842632791314 +0.17870000000000003 0.5623904560716133 0.5623893737045501 1.038102563133414e-06 -0.026512966547477475 +0.17880000000000001 0.5624218544774556 0.562420753731227 1.0376239699128043e-06 -0.02652708932452298 +0.1789 0.5624532485993672 0.5624521294794199 1.0369887016858925e-06 -0.026541210963413504 +0.179 0.5624846384355815 0.5624835009500437 1.036196773218645e-06 -0.026555331463634976 +0.1791 0.5625160239843316 0.5625148681440144 1.0352482221476222e-06 -0.02656945082467347 +0.17920000000000003 0.5625474052438518 0.5625462310622478 1.0341431090354902e-06 -0.026583569046015217 +0.17930000000000001 0.562578782212376 0.5625775897056602 1.0328815176485762e-06 -0.026597686127146625 +0.1794 0.5626101548881396 0.562608944075168 1.0314635545127793e-06 -0.026611802067554383 +0.1795 0.5626415232693787 0.5626402941716875 1.0298893492466377e-06 -0.026625916866725264 +0.1796 0.5626728873543304 0.5626716399961345 1.0281590543392838e-06 -0.02664003052414629 +0.17970000000000003 0.5627042471412336 0.5627029815494244 1.026272845372489e-06 -0.026654143039304697 +0.17980000000000002 0.5627356026283287 0.5627343188324718 1.0242309210761746e-06 -0.026668254411687825 +0.1799 0.5627669538138574 0.5627656518461904 1.022033502884323e-06 -0.026682364640783246 +0.18 0.5627983006960638 0.5627969805914927 1.019680835157022e-06 -0.02669647372607874 +0.1801 0.5628296432731945 0.5628283050692899 1.0171731853469979e-06 -0.026710581667062278 +0.18020000000000003 0.5628609815434976 0.5628596252804916 1.0145108439441053e-06 -0.026724688463221985 +0.18030000000000002 0.5628923155052244 0.5628909412260057 1.011694123975726e-06 -0.026738794114046206 +0.1804 0.5629236451566287 0.5629222529067381 1.0087233614508584e-06 -0.026752898619023413 +0.1805 0.5629549704959673 0.5629535603235928 1.0055989153046063e-06 -0.026767001977642348 +0.1806 0.5629862915215003 0.5629848634774712 1.002321167009601e-06 -0.026781104189391853 +0.18070000000000003 0.5630176082314909 0.5630161623692724 9.98890521186624e-07 -0.02679520525376108 +0.18080000000000002 0.5630489206242061 0.5630474569998927 9.953074047164279e-07 -0.02680930517023927 +0.1809 0.5630802286979164 0.5630787473702256 9.915722670172933e-07 -0.026823403938315893 +0.181 0.5631115324508965 0.5631100334811612 9.87685580766673e-07 -0.026837501557480603 +0.1811 0.5631428318814249 0.5631413153335866 9.836478409575022e-07 -0.026851598027223256 +0.18120000000000003 0.5631741269877848 0.5631725929283851 9.79459564676155e-07 -0.026865693347033856 +0.18130000000000002 0.5632054177682635 0.5632038662664366 9.751212916020435e-07 -0.02687978751640262 +0.1814 0.5632367042211532 0.563235135348617 9.70633584174152e-07 -0.02689388053481997 +0.1815 0.5632679863447512 0.5632664001757983 9.65997026591836e-07 -0.026907972401776503 +0.1816 0.5632992641373598 0.563297660748848 9.612122254809563e-07 -0.026922063116763 +0.18170000000000003 0.5633305375972862 0.5633289170686292 9.56279809671834e-07 -0.026936152679270443 +0.18180000000000002 0.5633618067228439 0.5633601691360004 9.512004300882282e-07 -0.02695024108878999 +0.1819 0.5633930715123509 0.5633914169518148 9.459747597473367e-07 -0.026964328344813018 +0.182 0.5634243319641323 0.5634226605169216 9.406034933157059e-07 -0.026978414446831068 +0.1821 0.5634555880765185 0.5634538998321639 9.350873473867871e-07 -0.026992499394335887 +0.18220000000000003 0.5634868398478464 0.5634851348983796 9.294270602588917e-07 -0.02700658318681938 +0.18230000000000002 0.5635180872764591 0.5635163657164008 9.236233922127468e-07 -0.027020665823773646 +0.1824 0.5635493303607069 0.5635475922870548 9.176771247898508e-07 -0.027034747304691027 +0.1825 0.563580569098946 0.5635788146111612 9.115890607924726e-07 -0.027048827629064 +0.1826 0.5636118034895405 0.5636100326895351 9.053600246167193e-07 -0.02706290679638525 +0.18270000000000003 0.5636430335308611 0.5636412465229843 8.989908619749798e-07 -0.02707698480614768 +0.18280000000000002 0.5636742592212859 0.5636724561123102 8.924824395073472e-07 -0.027091061657844306 +0.1829 0.5637054805592007 0.5637036614583077 8.858356449481519e-07 -0.02710513735096842 +0.183 0.5637366975429992 0.5637348625617649 8.790513867373839e-07 -0.02711921188501347 +0.1831 0.5637679101710826 0.5637660594234624 8.721305944647817e-07 -0.02713328525947306 +0.18320000000000003 0.5637991184418607 0.5637972520441737 8.650742180926763e-07 -0.027147357473841074 +0.18330000000000002 0.563830322353751 0.5638284404246654 8.578832285111027e-07 -0.027161428527611484 +0.1834 0.5638615219051799 0.5638596245656957 8.505586162055323e-07 -0.027175498420278516 +0.1835 0.5638927170945821 0.5638908044680153 8.431013927279185e-07 -0.02718956715133658 +0.1836 0.5639239079204015 0.5639219801323669 8.355125895587179e-07 -0.027203634720280256 +0.18370000000000003 0.5639550943810905 0.5639531515594851 8.277932578848457e-07 -0.02721770112660432 +0.18380000000000002 0.5639862764751109 0.5639843187500961 8.199444691270319e-07 -0.027231766369803734 +0.1839 0.564017454200934 0.5640154817049179 8.119673141904205e-07 -0.02724583044937371 +0.184 0.5640486275570402 0.5640466404246592 8.038629036588585e-07 -0.027259893364809558 +0.1841 0.56407979654192 0.5640777949100206 7.956323673785626e-07 -0.027273955115606825 +0.18420000000000003 0.5641109611540733 0.564108945161693 7.872768546246522e-07 -0.02728801570126125 +0.18430000000000002 0.5641421213920106 0.5641400911803587 7.787975336293051e-07 -0.027302075121268768 +0.1844 0.5641732772542519 0.5641712329666903 7.70195591720535e-07 -0.027316133375125496 +0.1845 0.564204428739328 0.564202370521351 7.614722349058578e-07 -0.02733019046232775 +0.18460000000000001 0.5642355758457799 0.5642335038449942 7.526286879000477e-07 -0.027344246382372 +0.18470000000000003 0.5642667185721596 0.5642646329382636 7.436661938753364e-07 -0.027358301134754973 +0.18480000000000002 0.5642978569170296 0.5642957578017931 7.345860140728355e-07 -0.027372354718973535 +0.1849 0.5643289908789637 0.5643268784362059 7.253894280523365e-07 -0.02738640713452476 +0.185 0.5643601204565466 0.5643579948421156 7.16077733220466e-07 -0.027400458380905914 +0.18510000000000001 0.5643912456483745 0.5643891070201245 7.0665224480293e-07 -0.027414508457614475 +0.1852 0.564422366453055 0.5644202149708246 6.971142956224696e-07 -0.02742855736414808 +0.18530000000000002 0.5644534828692073 0.5644513186947976 6.874652356825273e-07 -0.02744260510000456 +0.1854 0.5644845948954623 0.5644824181926136 6.777064324725579e-07 -0.027456651664681964 +0.1855 0.5645157025304629 0.5645135134648316 6.678392702186287e-07 -0.027470697057678496 +0.18560000000000001 0.5645468057728641 0.5645446045119998 6.57865149994441e-07 -0.02748474127849257 +0.1857 0.5645779046213331 0.5645756913346551 6.477854897213309e-07 -0.027498784326622828 +0.18580000000000002 0.5646089990745493 0.564606773933322 6.376017236409126e-07 -0.027512826201568037 +0.1859 0.5646400891312049 0.5646378523085144 6.273153019820121e-07 -0.02752686690282721 +0.186 0.5646711747900046 0.5646689264607336 6.169276913214894e-07 -0.027540906429899516 +0.18610000000000002 0.5647022560496658 0.5646999963904693 6.064403737515711e-07 -0.027554944782284353 +0.1862 0.5647333329089192 0.5647310620981987 5.958548472961844e-07 -0.027568981959481265 +0.18630000000000002 0.5647644053665081 0.5647621235843872 5.851726251338008e-07 -0.027583017960990032 +0.1864 0.5647954734211891 0.5647931808494876 5.743952355696802e-07 -0.027597052786310583 +0.1865 0.5648265370717327 0.5648242338939404 5.635242221191383e-07 -0.027611086434943102 +0.18660000000000002 0.5648575963169222 0.5648552827181732 5.525611427581456e-07 -0.027625118906387913 +0.1867 0.5648886511555549 0.5648863273226008 5.415075702563943e-07 -0.02763915020014553 +0.18680000000000002 0.5649197015864414 0.5649173677076251 5.303650915666758e-07 -0.02765318031571667 +0.1869 0.5649507476084069 0.5649484038736353 5.191353076305916e-07 -0.027667209252602288 +0.187 0.5649817892202899 0.5649794358210071 5.078198334340644e-07 -0.027681237010303464 +0.18710000000000002 0.5650128264209432 0.5650104635501029 4.964202972856935e-07 -0.027695263588321507 +0.1872 0.5650438592092342 0.5650414870612719 4.849383411775765e-07 -0.0277092889861579 +0.18730000000000002 0.565074887584044 0.5650725063548496 4.7337562011917633e-07 -0.027723313203314344 +0.1874 0.5651059115442689 0.565103521431158 4.6173380210956516e-07 -0.027737336239292722 +0.1875 0.5651369310888193 0.5651345322905053 4.5001456761006864e-07 -0.027751358093595094 +0.18760000000000002 0.5651679462166201 0.5651655389331856 4.3821960976631047e-07 -0.02776537876572372 +0.1877 0.5651989569266118 0.5651965413594793 4.2635063393636763e-07 -0.02777939825518106 +0.18780000000000002 0.565229963217749 0.5652275395696527 4.1440935724668115e-07 -0.027793416561469775 +0.1879 0.565260965089002 0.5652585335639577 4.0239750867532287e-07 -0.02780743368409271 +0.188 0.5652919625393557 0.5652895233426319 3.903168284691283e-07 -0.027821449622552893 +0.18810000000000002 0.5653229555678104 0.5653205089058987 3.781690683518635e-07 -0.02783546437635357 +0.1882 0.5653539441733818 0.5653514902539671 3.6595599077482444e-07 -0.027849477944998147 +0.18830000000000002 0.5653849283551013 0.5653824673870312 3.536793689723483e-07 -0.02786349032799027 +0.1884 0.5654159081120153 0.5654134403052702 3.413409866703798e-07 -0.02787750152483372 +0.1885 0.565446883443186 0.5654444090088488 3.289426377395266e-07 -0.027891511535032523 +0.18860000000000002 0.5654778543476919 0.565475373497917 3.1648612594525893e-07 -0.02790552035809087 +0.1887 0.5655088208246264 0.5655063337726096 3.039732647119875e-07 -0.027919527993513146 +0.18880000000000002 0.5655397828730993 0.5655372898330461 2.914058769981631e-07 -0.027933534440803945 +0.1889 0.5655707404922361 0.565568241679331 2.7878579478279875e-07 -0.027947539699468033 +0.189 0.565601693681179 0.5655991893115541 2.661148589266915e-07 -0.027961543769010406 +0.18910000000000002 0.5656326424390856 0.565630132729789 2.533949189642559e-07 -0.027975546648936225 +0.1892 0.5656635867651302 0.5656610719340943 2.406278327288236e-07 -0.027989548338750836 +0.18930000000000002 0.565694526658503 0.5656920069245132 2.2781546613059867e-07 -0.0280035488379598 +0.1894 0.5657254621184109 0.5657229377010733 2.14959692879102e-07 -0.028017548146068855 +0.1895 0.5657563931440774 0.5657538642637867 2.0206239419173766e-07 -0.02803154626258397 +0.18960000000000002 0.565787319734742 0.5657847866126493 1.8912545858562613e-07 -0.028045543187011253 +0.1897 0.5658182418896612 0.5658157047476422 1.7615078150290397e-07 -0.02805953891885706 +0.18980000000000002 0.5658491596081081 0.5658466186687294 1.6314026510949597e-07 -0.028073533457627888 +0.1899 0.5658800728893726 0.5658775283758601 1.500958179342926e-07 -0.028087526802830505 +0.19 0.5659109817327608 0.5659084338689673 1.3701935473731108e-07 -0.02810151895397178 +0.19010000000000002 0.5659418861375962 0.5659393351479671 1.239127960933617e-07 -0.028115509910558823 +0.1902 0.5659727861032191 0.5659702322127607 1.1077806819081992e-07 -0.02812949967209896 +0.19030000000000002 0.5660036816289868 0.5660011250632329 9.761710244304833e-08 -0.02814348823809966 +0.1904 0.5660345727142735 0.5660320136992519 8.443183533574095e-08 -0.028157475608068645 +0.1905 0.5660654593584702 0.5660628981206703 7.122420807997853e-08 -0.02817146178151378 +0.19060000000000002 0.5660963415609851 0.5660937783273239 5.799616629997839e-08 -0.028185446757943152 +0.1907 0.5661272193212438 0.5661246543190326 4.4749659811049725e-08 -0.02819943053686504 +0.19080000000000003 0.5661580926386888 0.5661555260955995 3.148664228305731e-08 -0.028213413117787908 +0.19090000000000001 0.5661889615127799 0.5661863936568118 1.8209070966335172e-08 -0.028227394500220417 +0.191 0.5662198259429941 0.5662172570024399 4.918906400253054e-09 -0.028241374683671425 +0.19110000000000002 0.5662506859288259 0.566248116132238 -8.381887862604631e-09 -0.02825535366764999 +0.1912 0.5662815414697866 0.5662789710459438 -2.1691345558280672e-08 -0.028269331451665367 +0.1913 0.5663123925654057 0.5663098217432788 -3.500749799073555e-08 -0.028283308035227012 +0.19140000000000001 0.5663432392152289 0.5663406682239471 -4.8328374343230285e-08 -0.028297283417844543 +0.1915 0.5663740814188203 0.5663715104876367 -6.165200195588222e-08 -0.028311257599027792 +0.19160000000000002 0.5664049191757609 0.5664023485340194 -7.497640662143534e-08 -0.02832523057828681 +0.1917 0.5664357524856491 0.5664331823627495 -8.82996128801633e-08 -0.0283392023551318 +0.1918 0.5664665813481012 0.566464011973466 -1.0161964430696613e-07 -0.028353172929073186 +0.19190000000000002 0.5664974057627505 0.5664948373657899 -1.1493452381321212e-07 -0.028367142299621596 +0.192 0.5665282257292478 0.5665256585393263 -1.282422739286304e-07 -0.02838111046628782 +0.19210000000000002 0.5665590412472614 0.5665564754936642 -1.415409171048876e-07 -0.028395077428582896 +0.1922 0.5665898523164773 0.5665872882283743 -1.5482847603304206e-07 -0.028409043186018015 +0.1923 0.5666206589365987 0.5666180967430123 -1.6810297389160955e-07 -0.028423007738104557 +0.19240000000000002 0.5666514611073465 0.5666489010371161 -1.8136243464667023e-07 -0.028436971084354112 +0.1925 0.566682258828459 0.5666797011102079 -1.9460488339534399e-07 -0.028450933224278503 +0.19260000000000002 0.5667130520996918 0.5667104969617927 -2.078283466017128e-07 -0.028464894157389693 +0.1927 0.5667438409208181 0.5667412885913583 -2.2103085245417375e-07 -0.028478853883199852 +0.1928 0.5667746252916289 0.5667720759983772 -2.3421043111176987e-07 -0.028492812401221382 +0.19290000000000002 0.566805405211932 0.5668028591823043 -2.4736511498868463e-07 -0.028506769710966842 +0.193 0.5668361806815533 0.5668336381425783 -2.6049293912894234e-07 -0.028520725811948984 +0.19310000000000002 0.5668669517003354 0.5668644128786208 -2.735919414006971e-07 -0.028534680703680784 +0.1932 0.5668977182681388 0.5668951833898374 -2.8666016281542195e-07 -0.028548634385675398 +0.1933 0.5669284803848413 0.5669259496756172 -2.9969564792342585e-07 -0.0285625868574462 +0.19340000000000002 0.566959238050338 0.5669567117353322 -3.126964449318148e-07 -0.028576538118506717 +0.1935 0.5669899912645414 0.5669874695683386 -3.256606061347034e-07 -0.028590488168370717 +0.19360000000000002 0.5670207400273809 0.5670182231739754 -3.3858618821158704e-07 -0.02860443700655213 +0.1937 0.5670514843388036 0.5670489725515659 -3.5147125240775345e-07 -0.028618384632565098 +0.1938 0.5670822241987736 0.5670797177004163 -3.6431386493673834e-07 -0.028632331045923966 +0.19390000000000002 0.5671129596072725 0.5671104586198168 -3.771120972440034e-07 -0.02864627624614324 +0.194 0.5671436905642987 0.5671411953090416 -3.898640261873476e-07 -0.028660220232737704 +0.19410000000000002 0.5671744170698675 0.5671719277673481 -4.0256773448099636e-07 -0.02867416300522224 +0.1942 0.5672051391240119 0.5672026559939776 -4.152213109870351e-07 -0.028688104563111962 +0.1943 0.5672358567267816 0.5672333799881553 -4.2782285085418703e-07 -0.028702044905922215 +0.19440000000000002 0.567266569878243 0.5672640997490904 -4.4037045603129155e-07 -0.028715984033168513 +0.1945 0.5672972785784797 0.5672948152759758 -4.528622352395484e-07 -0.028729921944366577 +0.19460000000000002 0.5673279828275921 0.5673255265679883 -4.6529630454150706e-07 -0.02874385863903229 +0.1947 0.5673586826256973 0.5673562336242889 -4.776707874798447e-07 -0.028757794116681765 +0.1948 0.5673893779729293 0.5673869364440228 -4.89983815479822e-07 -0.02877172837683132 +0.19490000000000002 0.5674200688694386 0.5674176350263193 -5.022335280574497e-07 -0.028785661418997445 +0.195 0.5674507553153926 0.5674483293702917 -5.144180730831671e-07 -0.028799593242696844 +0.19510000000000002 0.5674814373109746 0.5674790194750375 -5.265356070316418e-07 -0.028813523847446388 +0.1952 0.5675121148563851 0.5675097053396392 -5.385842954397368e-07 -0.02882745323276319 +0.1953 0.5675427879518404 0.5675403869631631 -5.505623131285553e-07 -0.028841381398164525 +0.19540000000000002 0.5675734565975735 0.5675710643446602 -5.624678440785402e-07 -0.028855308343167886 +0.1955 0.5676041207938336 0.5676017374831663 -5.742990825119421e-07 -0.02886923406729096 +0.19560000000000002 0.5676347805408858 0.5676324063777016 -5.860542323377071e-07 -0.02888315857005161 +0.1957 0.5676654358390116 0.5676630710272711 -5.97731507984145e-07 -0.028897081850967933 +0.1958 0.5676960866885082 0.5676937314308647 -6.093291344266838e-07 -0.028911003909558183 +0.19590000000000002 0.5677267330896891 0.567724387587457 -6.208453476042042e-07 -0.028924924745340842 +0.196 0.5677573750428832 0.5677550394960079 -6.322783945023058e-07 -0.028938844357834566 +0.19610000000000002 0.5677880125484349 0.5677856871554623 -6.436265335973967e-07 -0.028952762746558225 +0.1962 0.5678186456067054 0.5678163305647503 -6.548880350232267e-07 -0.028966679911030902 +0.1963 0.56784927421807 0.5678469697227874 -6.660611807929318e-07 -0.02898059585077184 +0.19640000000000002 0.5678798983829204 0.567877604628474 -6.77144265354146e-07 -0.028994510565300502 +0.1965 0.567910518101663 0.5679082352806968 -6.8813559553349e-07 -0.029008424054136547 +0.19660000000000002 0.5679411333747202 0.5679388616783273 -6.990334908973939e-07 -0.029022336316799836 +0.1967 0.5679717442025287 0.5679694838202232 -7.098362838631189e-07 -0.029036247352810407 +0.1968 0.5680023505855407 0.568000101705228 -7.205423202538697e-07 -0.029050157161688513 +0.19690000000000002 0.568032952524223 0.5680307153321708 -7.311499595485937e-07 -0.029064065742954604 +0.197 0.5680635500190576 0.5680613246998668 -7.41657574881982e-07 -0.02907797309612933 +0.19710000000000003 0.5680941430705408 0.5680919298071178 -7.520635533497799e-07 -0.02909187922073353 +0.19720000000000001 0.5681247316791839 0.5681225306527113 -7.623662962863431e-07 -0.02910578411628827 +0.1973 0.5681553158455117 0.5681531272354216 -7.725642197087268e-07 -0.029119687782314753 +0.1974 0.5681858955700645 0.5681837195540094 -7.826557544554635e-07 -0.029133590218334462 +0.1975 0.5682164708533959 0.5682143076072215 -7.926393462420744e-07 -0.02914749142386898 +0.19760000000000003 0.5682470416960741 0.5682448913937923 -8.025134561051583e-07 -0.029161391398440165 +0.19770000000000001 0.5682776080986808 0.5682754709124425 -8.122765606244364e-07 -0.029175290141570054 +0.1978 0.5683081700618118 0.5683060461618801 -8.219271519227522e-07 -0.029189187652780862 +0.1979 0.5683387275860768 0.5683366171408003 -8.314637383877166e-07 -0.029203083931595042 +0.198 0.5683692806720986 0.5683671838478852 -8.408848444219075e-07 -0.029216978977535214 +0.19810000000000003 0.5683998293205134 0.568397746281805 -8.501890109424703e-07 -0.029230872790124204 +0.19820000000000002 0.5684303735319707 0.5684283044412166 -8.59374795519896e-07 -0.02924476536888504 +0.1983 0.5684609133071336 0.5684588583247652 -8.684407727110877e-07 -0.029258656713340932 +0.1984 0.5684914486466776 0.5684894079310836 -8.773855340871162e-07 -0.029272546823015312 +0.1985 0.5685219795512912 0.5685199532587929 -8.862076886773096e-07 -0.029286435697431803 +0.19860000000000003 0.568552506021676 0.5685504943065017 -8.94905862969253e-07 -0.029300323336114237 +0.19870000000000002 0.5685830280585455 0.5685810310728079 -9.034787014361445e-07 -0.02931420973858663 +0.1988 0.568613545662626 0.5686115635562965 -9.119248662592394e-07 -0.029328094904373173 +0.1989 0.568644058834656 0.568642091755542 -9.20243037938473e-07 -0.029341978832998307 +0.199 0.5686745675753855 0.5686726156691075 -9.284319156255272e-07 -0.029355861523986605 +0.19910000000000003 0.5687050718855773 0.5687031352955452 -9.364902169017864e-07 -0.029369742976862945 +0.19920000000000002 0.5687355717660058 0.5687336506333958 -9.44416678166915e-07 -0.02938362319115233 +0.1993 0.5687660672174564 0.5687641616811896 -9.522100548331469e-07 -0.029397502166379954 +0.1994 0.5687965582407264 0.5687946684374459 -9.598691217416189e-07 -0.02941137990207119 +0.1995 0.5688270448366244 0.5688251709006741 -9.673926730235927e-07 -0.02942525639775171 +0.19960000000000003 0.56885752700597 0.5688556690693729 -9.747795226000555e-07 -0.029439131652947283 +0.19970000000000002 0.5688880047495938 0.568886162942031 -9.820285040706977e-07 -0.02945300566718394 +0.1998 0.5689184780683371 0.5689166525171272 -9.89138470963713e-07 -0.02946687843998786 +0.1999 0.568948946963052 0.5689471377931306 -9.961082972353985e-07 -0.02948074997088553 +0.2 0.5689794114346007 0.5689776187685002 -1.0029368769925995e-06 -0.029494620259403467 +0.20010000000000003 0.569009871483856 0.569008095441686 -1.0096231250478205e-06 -0.029508489305068525 +0.20020000000000002 0.5690403271117008 0.5690385678111285 -1.016165977085759e-06 -0.029522357107407693 +0.2003 0.5690707783190274 0.5690690358752593 -1.0225643893302383e-06 -0.029536223665948165 +0.2004 0.5691012251067387 0.5690994996325013 -1.0288173392103417e-06 -0.029550088980217378 +0.2005 0.5691316674757463 0.5691299590812682 -1.0349238255824567e-06 -0.029563953049742932 +0.20060000000000003 0.5691621054269717 0.569160414219965 -1.040882868674764e-06 -0.0295778158740526 +0.20070000000000002 0.5691925389613451 0.5691908650469891 -1.0466935099207042e-06 -0.029591677452674398 +0.2008 0.5692229680798064 0.5692213115607292 -1.0523548130692006e-06 -0.02960553778513658 +0.2009 0.5692533927833038 0.5692517537595662 -1.0578658632409699e-06 -0.02961939687096751 +0.201 0.5692838130727942 0.5692821916418729 -1.0632257682052781e-06 -0.029633254709695786 +0.20110000000000003 0.5693142289492431 0.5693126252060147 -1.068433657158696e-06 -0.029647111300850217 +0.20120000000000002 0.5693446404136241 0.5693430544503494 -1.0734886820573664e-06 -0.029660966643959813 +0.2013 0.569375047466919 0.5693734793732279 -1.078390017394959e-06 -0.029674820738553792 +0.2014 0.5694054501101173 0.5694038999729937 -1.0831368600916491e-06 -0.029688673584161523 +0.2015 0.5694358483442161 0.5694343162479837 -1.087728429882695e-06 -0.02970252518031264 +0.20160000000000003 0.5694662421702203 0.5694647281965279 -1.0921639694294605e-06 -0.029716375526536932 +0.20170000000000002 0.5694966315891419 0.5694951358169503 -1.0964427443194147e-06 -0.029730224622364406 +0.2018 0.5695270166020001 0.5695255391075681 -1.100564043343688e-06 -0.029744072467325272 +0.2019 0.5695573972098206 0.5695559380666927 -1.1045271784970723e-06 -0.02975791906094992 +0.202 0.5695877734136361 0.5695863326926294 -1.1083314850890424e-06 -0.029771764402768977 +0.20210000000000003 0.569618145214486 0.569616722983678 -1.1119763221323353e-06 -0.02978560849231321 +0.20220000000000002 0.5696485126134154 0.5696471089381334 -1.1154610721209046e-06 -0.0297994513291137 +0.2023 0.5696788756114759 0.5696774905542844 -1.118785141362988e-06 -0.029813292912701597 +0.2024 0.569709234209725 0.569707867830415 -1.1219479598145732e-06 -0.029827133242608318 +0.2025 0.5697395884092256 0.5697382407648043 -1.124948981467977e-06 -0.029840972318365445 +0.20260000000000003 0.5697699382110462 0.569768609355727 -1.1277876841297996e-06 -0.029854810139504834 +0.20270000000000002 0.5698002836162603 0.5697989736014533 -1.1304635700870591e-06 -0.02986864670555848 +0.2028 0.5698306246259472 0.569829333500249 -1.1329761655520798e-06 -0.02988248201605856 +0.2029 0.5698609612411901 0.5698596890503762 -1.1353250212176036e-06 -0.02989631607053755 +0.203 0.5698912934630774 0.569890040250093 -1.137509711868212e-06 -0.029910148868528014 +0.20310000000000003 0.5699216212927017 0.5699203870976535 -1.139529836990949e-06 -0.02992398040956275 +0.20320000000000002 0.5699519447311601 0.5699507295913092 -1.1413850203867426e-06 -0.02993781069317482 +0.2033 0.5699822637795533 0.569981067729308 -1.1430749106700056e-06 -0.029951639718897406 +0.2034 0.5700125784389856 0.5700114015098947 -1.1445991809910794e-06 -0.029965467486263928 +0.2035 0.5700428887105657 0.5700417309313117 -1.1459575294248125e-06 -0.029979293994808 +0.20360000000000003 0.5700731945954054 0.5700720559917986 -1.14714967847096e-06 -0.029993119244063476 +0.20370000000000002 0.5701034960946187 0.5701023766895927 -1.1481753760533842e-06 -0.030006943233564315 +0.2038 0.5701337932093237 0.5701326930229293 -1.149034394631876e-06 -0.030020765962844795 +0.2039 0.5701640859406403 0.5701630049900419 -1.1497265316462446e-06 -0.030034587431439275 +0.204 0.5701943742896918 0.570193312589162 -1.1502516095163173e-06 -0.030048407638882415 +0.20410000000000003 0.5702246582576032 0.5702236158185199 -1.150609475863984e-06 -0.030062226584709043 +0.20420000000000002 0.5702549378455013 0.5702539146763448 -1.1508000033466637e-06 -0.03007604426845419 +0.2043 0.5702852130545156 0.5702842091608644 -1.1508230894907712e-06 -0.03008986068965306 +0.2044 0.5703154838857764 0.5703144992703062 -1.1506786573023398e-06 -0.03010367584784109 +0.2045 0.5703457503404158 0.5703447850028965 -1.1503666549339542e-06 -0.03011748974255393 +0.20460000000000003 0.5703760124195671 0.5703750663568616 -1.1498870556847507e-06 -0.030131302373327375 +0.20470000000000002 0.5704062701243642 0.5704053433304279 -1.1492398581114394e-06 -0.030145113739697495 +0.2048 0.5704365234559425 0.5704356159218211 -1.1484250859172818e-06 -0.0301589238412005 +0.2049 0.5704667724154369 0.570465884129268 -1.1474427882851579e-06 -0.030172732677372822 +0.205 0.5704970170039836 0.5704961479509952 -1.146293039433477e-06 -0.0301865402477511 +0.20510000000000003 0.5705272572227182 0.5705264073852306 -1.1449759391712888e-06 -0.030200346551872165 +0.20520000000000002 0.5705574930727764 0.5705566624302028 -1.143491612121128e-06 -0.030214151589273066 +0.2053 0.5705877245552938 0.5705869130841418 -1.1418402084406587e-06 -0.0302279553594911 +0.2054 0.5706179516714049 0.5706171593452785 -1.140021903656141e-06 -0.03024175786206364 +0.2055 0.570648174422244 0.5706474012118458 -1.1380368982738531e-06 -0.03025555909652837 +0.20560000000000003 0.5706783928089438 0.5706776386820782 -1.1358854184462253e-06 -0.030269359062423142 +0.20570000000000002 0.5707086068326362 0.5707078717542127 -1.1335677151946832e-06 -0.03028315775928599 +0.2058 0.5707388164944516 0.5707381004264879 -1.131084064853738e-06 -0.03029695518665514 +0.2059 0.5707690217955181 0.5707683246971452 -1.1284347689599628e-06 -0.030310751344069072 +0.206 0.5707992227369632 0.5707985445644289 -1.1256201541409716e-06 -0.03032454623106645 +0.20610000000000003 0.570829419319911 0.5708287600265861 -1.1226405723374633e-06 -0.030338339847186147 +0.20620000000000002 0.570859611545484 0.570858971081867 -1.11949640024811e-06 -0.030352132191967182 +0.2063 0.5708897994148021 0.5708891777285252 -1.116188039829158e-06 -0.030365923264948875 +0.2064 0.5709199829289822 0.5709193799648179 -1.1127159180723822e-06 -0.030379713065670638 +0.2065 0.5709501620891381 0.5709495777890059 -1.1090804868940651e-06 -0.030393501593672212 +0.20660000000000003 0.5709803368963808 0.5709797711993543 -1.1052822226909065e-06 -0.03040728884849339 +0.20670000000000002 0.5710105073518176 0.5710099601941323 -1.1013216271726911e-06 -0.030421074829674283 +0.2068 0.5710406734565523 0.5710401447716134 -1.0971992269737108e-06 -0.030434859536755177 +0.2069 0.5710708352116849 0.5710703249300763 -1.092915572875608e-06 -0.030448642969276542 +0.207 0.5711009926183112 0.5711005006678038 -1.0884712406400432e-06 -0.030462425126779033 +0.20710000000000003 0.5711311456775227 0.5711306719830845 -1.0838668306201171e-06 -0.03047620600880358 +0.20720000000000002 0.5711612943904064 0.571160838874212 -1.0791029675938368e-06 -0.03048998561489126 +0.2073 0.5711914387580447 0.5711910013394854 -1.0741803008196271e-06 -0.030503763944583342 +0.2074 0.5712215787815148 0.5712211593772096 -1.0690995037032636e-06 -0.03051754099742129 +0.2075 0.5712517144618889 0.5712513129856956 -1.063861274297473e-06 -0.030531316772946848 +0.20760000000000003 0.5712818458002343 0.5712814621632606 -1.0584663344692657e-06 -0.030545091270701936 +0.20770000000000002 0.5713119727976119 0.5713116069082276 -1.0529154301774923e-06 -0.030558864490228595 +0.2078 0.5713420954550776 0.5713417472189269 -1.0472093313618203e-06 -0.030572636431069146 +0.2079 0.571372213773681 0.5713718830936955 -1.0413488321092679e-06 -0.030586407092766117 +0.208 0.5714023277544652 0.5714020145308768 -1.0353347499880705e-06 -0.030600176474862198 +0.20810000000000003 0.5714324373984669 0.5714321415288222 -1.0291679264362585e-06 -0.03061394457690031 +0.20820000000000002 0.571462542706717 0.5714622640858901 -1.0228492260955235e-06 -0.03062771139842356 +0.2083 0.5714926436802388 0.5714923822004465 -1.016379537088774e-06 -0.030641476938975294 +0.2084 0.5715227403200489 0.5715224958708658 -1.0097597713532025e-06 -0.030655241198099016 +0.2085 0.5715528326271564 0.5715526050955295 -1.0029908635300622e-06 -0.030669004175338438 +0.20860000000000004 0.5715829206025631 0.5715827098728283 -9.960737715197787e-07 -0.03068276587023754 +0.20870000000000002 0.5716130042472632 0.5716128102011608 -9.89009476037861e-07 -0.03069652628234041 +0.2088 0.5716430835622434 0.5716429060789343 -9.81798980670412e-07 -0.03071028541119138 +0.2089 0.5716731585484816 0.5716729975045652 -9.744433115688178e-07 -0.030724043256335012 +0.209 0.5717032292069478 0.5717030844764787 -9.66943517421992e-07 -0.030737799817316017 +0.20910000000000004 0.5717332955386039 0.5717331669931093 -9.5930066942862e-07 -0.03075155509367938 +0.20920000000000002 0.5717633575444026 0.571763245052901 -9.51515860880825e-07 -0.030765309084970213 +0.2093 0.5717934152252884 0.5717933186543077 -9.435902071919244e-07 -0.03077906179073392 +0.2094 0.5718234685821961 0.5718233877957928 -9.355248456466292e-07 -0.030792813210516037 +0.2095 0.5718535176160517 0.5718534524758296 -9.273209355398215e-07 -0.030806563343862295 +0.20960000000000004 0.5718835623277718 0.5718835126929023 -9.189796572051101e-07 -0.030820312190318708 +0.20970000000000003 0.571913602718263 0.5719135684455048 -9.10502212986275e-07 -0.030834059749431365 +0.20980000000000001 0.5719436387884227 0.571943619732142 -9.018898261270447e-07 -0.03084780602074674 +0.2099 0.5719736705391378 0.5719736665513293 -8.931437411041632e-07 -0.03086155100381135 +0.21 0.5720036979712854 0.5720037089015936 -8.842652234331005e-07 -0.030875294698171976 +0.2101 0.5720337210857319 0.5720337467814722 -8.752555590851863e-07 -0.030889037103375594 +0.21020000000000003 0.5720637398833331 0.5720637801895148 -8.661160548484315e-07 -0.030902778218969397 +0.21030000000000001 0.5720937543649349 0.5720938091242815 -8.568480375503729e-07 -0.030916518044500813 +0.2104 0.5721237645313715 0.5721238335843449 -8.474528546131843e-07 -0.03093025657951742 +0.2105 0.572153770383466 0.5721538535682892 -8.37931873054476e-07 -0.03094399382356701 +0.2106 0.5721837719220308 0.5721838690747107 -8.282864800979173e-07 -0.030957729776197585 +0.21070000000000003 0.5722137691478665 0.5722138801022181 -8.185180821740357e-07 -0.030971464436957363 +0.21080000000000002 0.5722437620617619 0.5722438866494322 -8.086281053087951e-07 -0.03098519780539474 +0.2109 0.5722737506644944 0.5722738887149865 -7.986179946795069e-07 -0.030998929881058363 +0.211 0.5723037349568295 0.5723038862975274 -7.884892144482958e-07 -0.03101266066349703 +0.2111 0.57233371493952 0.5723338793957145 -7.782432475678114e-07 -0.031026390152259754 +0.21120000000000003 0.572363690613307 0.5723638680082196 -7.678815955314278e-07 -0.031040118346895768 +0.21130000000000002 0.572393661978919 0.5723938521337286 -7.574057780956878e-07 -0.031053845246954526 +0.2114 0.572423629037072 0.5724238317709407 -7.468173334190809e-07 -0.031067570851985672 +0.2115 0.5724535917884689 0.5724538069185683 -7.361178172293759e-07 -0.031081295161539027 +0.2116 0.5724835502337997 0.5724837775753377 -7.253088031566879e-07 -0.031095018175164624 +0.21170000000000003 0.5725135043737416 0.5725137437399895 -7.143918820951001e-07 -0.031108739892412758 +0.21180000000000002 0.5725434542089584 0.572543705411278 -7.03368662369197e-07 -0.031122460312833857 +0.2119 0.5725733997401005 0.5725736625879716 -6.922407690401755e-07 -0.031136179435978597 +0.212 0.5726033409678046 0.5726036152688534 -6.810098441001333e-07 -0.031149897261397837 +0.2121 0.5726332778926939 0.5726335634527209 -6.696775460557358e-07 -0.031163613788642665 +0.21220000000000003 0.5726632105153777 0.572663507138386 -6.582455496506601e-07 -0.03117732901726432 +0.21230000000000002 0.5726931388364513 0.5726934463246757 -6.467155455047724e-07 -0.031191042946814303 +0.2124 0.5727230628564957 0.572723381010432 -6.350892402529063e-07 -0.031204755576844302 +0.2125 0.5727529825760778 0.5727533111945117 -6.233683558232173e-07 -0.031218466906906196 +0.2126 0.5727828979957502 0.5727832368757871 -6.115546296314722e-07 -0.031232176936552093 +0.21270000000000003 0.5728128091160507 0.5728131580531459 -5.996498139149153e-07 -0.03124588566533429 +0.21280000000000002 0.5728427159375025 0.5728430747254911 -5.876556758988016e-07 -0.0312595930928053 +0.2129 0.5728726184606139 0.5728729868917415 -5.755739971025076e-07 -0.031273299218517826 +0.213 0.5729025166858782 0.5729028945508315 -5.634065733117755e-07 -0.03128700404202479 +0.2131 0.5729324106137739 0.5729327977017117 -5.511552144399356e-07 -0.031300707562879296 +0.21320000000000003 0.5729623002447639 0.5729626963433482 -5.388217439450393e-07 -0.03131440978063467 +0.21330000000000002 0.5729921855792961 0.5729925904747238 -5.264079988021031e-07 -0.03132811069484447 +0.2134 0.5730220666178027 0.5730224800948374 -5.13915829225553e-07 -0.03134181030506241 +0.2135 0.5730519433607005 0.573052365202704 -5.013470981418688e-07 -0.03135550861084243 +0.2136 0.5730818158083907 0.5730822457973556 -4.887036812312173e-07 -0.0313692056117387 +0.21370000000000003 0.573111683961258 0.5731121218778401 -4.75987466483363e-07 -0.031382901307305526 +0.21380000000000002 0.573141547819672 0.5731419934432231 -4.63200353878479e-07 -0.0313965956970975 +0.2139 0.5731714073839861 0.5731718604925864 -4.5034425530388056e-07 -0.03141028878066939 +0.214 0.5732012626545373 0.5732017230250287 -4.374210940821799e-07 -0.03142398055757615 +0.2141 0.5732311136316466 0.573231581039666 -4.2443280474924183e-07 -0.03143767102737296 +0.21420000000000003 0.5732609603156182 0.5732614345356316 -4.1138133276275024e-07 -0.031451360189615196 +0.21430000000000002 0.5732908027067407 0.5732912835120756 -3.9826863425240777e-07 -0.03146504804385845 +0.2144 0.5733206408052851 0.5733211279681656 -3.8509667553421334e-07 -0.03147873458965849 +0.2145 0.5733504746115067 0.573350967903087 -3.7186743317985105e-07 -0.03149241982657134 +0.2146 0.5733803041256436 0.5733808033160424 -3.5858289339218974e-07 -0.03150610375415319 +0.21470000000000003 0.5734101293479171 0.573410634206252 -3.4524505185262733e-07 -0.03151978637196045 +0.21480000000000002 0.5734399502785317 0.573440460572954 -3.318559134019017e-07 -0.031533467679549725 +0.2149 0.5734697669176748 0.5734702824154041 -3.1841749176253487e-07 -0.03154714767647786 +0.215 0.5734995792655171 0.5735000997328761 -3.0493180919188845e-07 -0.03156082636230186 +0.2151 0.5735293873222117 0.5735299125246617 -2.9140089619072995e-07 -0.03157450373657897 +0.21520000000000003 0.5735591910878948 0.5735597207900703 -2.7782679118404374e-07 -0.03158817979886661 +0.21530000000000002 0.5735889905626848 0.5735895245284302 -2.642115403128642e-07 -0.03160185454872244 +0.2154 0.5736187857466831 0.573619323739087 -2.50557197024881e-07 -0.03161552798570432 +0.2155 0.5736485766399737 0.5736491184214052 -2.3686582173443327e-07 -0.03162920010937026 +0.2156 0.5736783632426231 0.5736789085747671 -2.231394816420984e-07 -0.03164287091927858 +0.21570000000000003 0.5737081455546801 0.573708694198574 -2.0938025033223617e-07 -0.03165654041498771 +0.21580000000000002 0.5737379235761758 0.5737384752922449 -1.955902074884941e-07 -0.031670208596056335 +0.2159 0.5737676973071235 0.573768251855218 -1.8177143854686273e-07 -0.03168387546204331 +0.216 0.5737974667475192 0.5737980238869496 -1.679260344597533e-07 -0.031697541012507754 +0.21610000000000001 0.5738272318973408 0.573827791386915 -1.5405609123803066e-07 -0.03171120524700894 +0.2162 0.5738569927565486 0.5738575543546076 -1.401637097844799e-07 -0.03172486816510639 +0.21630000000000002 0.5738867493250844 0.57388731278954 -1.2625099552257546e-07 -0.031738529766359797 +0.2164 0.5739165016028729 0.5739170666912433 -1.1232005805994483e-07 -0.03175219005032908 +0.2165 0.57394624958982 0.5739468160592675 -9.837301085183214e-08 -0.031765849016574345 +0.21660000000000001 0.5739759932858143 0.5739765608931814 -8.441197094435915e-08 -0.03177950666465592 +0.2167 0.5740057326907259 0.5740063011925725 -7.043905859462074e-08 -0.03179316299413434 +0.21680000000000002 0.5740354678044068 0.5740360369570475 -5.645639697231253e-08 -0.03180681800457033 +0.2169 0.5740651986266913 0.5740657681862319 -4.246611183967436e-08 -0.03182047169552485 +0.217 0.5740949251573951 0.57409549487977 -2.847033121582132e-08 -0.031834124066559055 +0.21710000000000002 0.574124647396316 0.5741252170373253 -1.4471185075443961e-08 -0.031847775117234293 +0.2172 0.5741543653432332 0.5741549346585804 -4.708050017551701e-10 -0.03186142484711212 +0.21730000000000002 0.5741840789979081 0.5741846477432363 1.3528676130747375e-08 -0.03187507325575432 +0.2174 0.574213788360084 0.5742143562910137 2.7525124483493424e-08 -0.03188872034272287 +0.2175 0.5742434934294854 0.5742440603016521 4.1516405566849324e-08 -0.03190236610757995 +0.21760000000000002 0.574273194205819 0.5742737597749101 5.550038458673745e-08 -0.03191601054988795 +0.2177 0.5743028906887734 0.5743034547105654 6.947492675948852e-08 -0.031929653669209496 +0.21780000000000002 0.5743325828780184 0.5743331451084147 8.343789764664322e-08 -0.031943295465107366 +0.2179 0.5743622707732056 0.5743628309682737 9.738716345852882e-08 -0.03195693593714459 +0.218 0.5743919543739685 0.5743925122899771 1.1132059139773443e-07 -0.03197057508488435 +0.21810000000000002 0.5744216336799225 0.574422189073379 1.2523605001646398e-07 -0.0319842129078901 +0.2182 0.5744513086906647 0.5744518613183527 1.3913140945592817e-07 -0.03199784940572548 +0.21830000000000002 0.5744809794057738 0.5744815290247898 1.5300454189737245e-07 -0.03201148457795432 +0.2184 0.5745106458248104 0.5745111921926014 1.6685332174248835e-07 -0.03202511842414068 +0.2185 0.5745403079473165 0.5745408508217179 1.8067562609219712e-07 -0.0320387509438488 +0.21860000000000002 0.5745699657728164 0.5745705049120882 1.9446933498257213e-07 -0.03205238213664315 +0.2187 0.5745996193008158 0.5746001544636806 2.082323316970891e-07 -0.03206601200208839 +0.21880000000000002 0.5746292685308027 0.574629799476482 2.2196250314826527e-07 -0.03207964053974942 +0.2189 0.5746589134622468 0.5746594399504983 2.3565774019684849e-07 -0.032093267749191294 +0.219 0.5746885540945994 0.5746890758857546 2.493159379501897e-07 -0.03210689362997932 +0.21910000000000002 0.5747181904272941 0.5747187072822946 2.629349959981653e-07 -0.03212051818167899 +0.2192 0.5747478224597464 0.574748334140181 2.765128190029831e-07 -0.03213414140385603 +0.21930000000000002 0.5747774501913538 0.5747779564594948 2.900473167616324e-07 -0.032147763296076326 +0.2194 0.5748070736214959 0.5748075742403366 3.0353640460833997e-07 -0.032161383857906026 +0.2195 0.5748366927495338 0.5748371874828251 3.169780038725367e-07 -0.032175003088911434 +0.21960000000000002 0.5748663075748115 0.5748667961870979 3.303700419898803e-07 -0.03218862098865911 +0.2197 0.574895918096655 0.5748964003533111 3.437104528214441e-07 -0.032202237556715765 +0.21980000000000002 0.5749255243143725 0.5749259999816396 3.5699717729209546e-07 -0.03221585279264839 +0.2199 0.5749551262272543 0.5749555950722764 3.702281632933513e-07 -0.03222946669602413 +0.22 0.5749847238345732 0.5749851856254334 3.8340136629400057e-07 -0.03224307926641034 +0.22010000000000002 0.5750143171355847 0.5750147716413404 3.965147494927601e-07 -0.03225669050337459 +0.2202 0.5750439061295263 0.5750443531202462 4.095662843317527e-07 -0.03227030040648469 +0.22030000000000002 0.5750734908156183 0.575073930062417 4.225539505103848e-07 -0.03228390897530863 +0.2204 0.5751030711930637 0.575103502468138 4.354757365682138e-07 -0.03229751620941459 +0.2205 0.5751326472610478 0.575133070337712 4.4832964019025923e-07 -0.03231112210837098 +0.22060000000000002 0.5751622190187391 0.57516263367146 4.6111366827639166e-07 -0.03232472667174641 +0.2207 0.5751917864652886 0.5751921924697211 4.738258374686888e-07 -0.0323383298991097 +0.22080000000000002 0.5752213495998304 0.575221746732852 4.864641744151132e-07 -0.03235193179002989 +0.2209 0.5752509084214817 0.5752512964612274 4.990267160331907e-07 -0.0323655323440762 +0.221 0.5752804629293428 0.5752808416552396 5.11511509954099e-07 -0.032379131560818106 +0.22110000000000002 0.5753100131224967 0.575310382315299 5.239166145643015e-07 -0.03239272943982525 +0.2212 0.5753395590000103 0.5753399184418327 5.362400995745364e-07 -0.032406325980667484 +0.22130000000000002 0.5753691005609334 0.5753694500352858 5.48480046214106e-07 -0.03241992118291488 +0.2214 0.5753986378042997 0.5753989770961209 5.606345475916985e-07 -0.03243351504613775 +0.2215 0.5754281707291257 0.5754284996248171 5.727017087231445e-07 -0.03244710756990652 +0.22160000000000002 0.5754576993344125 0.5754580176218714 5.846796472808169e-07 -0.03246069875379194 +0.2217 0.5754872236191443 0.5754875310877975 5.965664937046533e-07 -0.03247428859736488 +0.22180000000000002 0.5755167435822897 0.5755170400231262 6.083603911188895e-07 -0.03248787710019648 +0.22190000000000001 0.5755462592228004 0.5755465444284049 6.200594963035044e-07 -0.03250146426185803 +0.222 0.5755757705396134 0.5755760443041978 6.316619794166645e-07 -0.03251505008192107 +0.22210000000000002 0.5756052775316489 0.5756055396510857 6.43166024549835e-07 -0.03252863455995735 +0.2222 0.5756347801978121 0.575635030469666 6.54569830005336e-07 -0.03254221769553881 +0.2223 0.5756642785369921 0.5756645167605523 6.658716086849203e-07 -0.03255579948823759 +0.22240000000000001 0.5756937725480629 0.5756939985243745 6.770695880620181e-07 -0.03256937993762607 +0.2225 0.5757232622298829 0.5757234757617783 6.88162010542559e-07 -0.03258295904327681 +0.22260000000000002 0.5757527475812959 0.5757529484734261 6.991471339923283e-07 -0.03259653680476258 +0.2227 0.5757822286011303 0.5757824166599956 7.100232320145228e-07 -0.032610113221656405 +0.2228 0.5758117052881995 0.5758118803221801 7.207885936999503e-07 -0.032623688293531454 +0.22290000000000001 0.5758411776413019 0.5758413394606888 7.314415246262307e-07 -0.03263726201996112 +0.223 0.575870645659222 0.5758707940762464 7.419803464969732e-07 -0.032650834400519045 +0.22310000000000002 0.5759001093407288 0.5759002441695928 7.524033977523992e-07 -0.03266440543477905 +0.2232 0.5759295686845781 0.5759296897414828 7.62709033902409e-07 -0.03267797512231515 +0.2233 0.5759590236895109 0.5759591307926866 7.728956275543375e-07 -0.03269154346270161 +0.22340000000000002 0.5759884743542537 0.5759885673239891 7.829615687737768e-07 -0.03270511045551285 +0.2235 0.5760179206775197 0.5760179993361896 7.929052653066204e-07 -0.03271867610032354 +0.22360000000000002 0.5760473626580082 0.5760474268301027 8.027251429676419e-07 -0.032732240396708544 +0.2237 0.5760768002944048 0.576076849806557 8.124196458070276e-07 -0.032745803344243006 +0.2238 0.5761062335853817 0.5761062682663952 8.219872361936442e-07 -0.03275936494250212 +0.22390000000000002 0.5761356625295976 0.5761356822104743 8.314263953423939e-07 -0.03277292519106142 +0.224 0.5761650871256984 0.576165091639665 8.407356234529928e-07 -0.03278648408949658 +0.22410000000000002 0.5761945073723168 0.5761944965548524 8.499134399320152e-07 -0.03280004163738354 +0.2242 0.5762239232680727 0.5762238969569344 8.589583834761605e-07 -0.032813597834298415 +0.2243 0.5762533348115737 0.5762532928468229 8.67869012738387e-07 -0.03282715267981757 +0.22440000000000002 0.5762827420014143 0.5762826842254428 8.766439060503561e-07 -0.03284070617351747 +0.2245 0.5763121448361774 0.5763120710937324 8.85281662033055e-07 -0.032854258314974925 +0.22460000000000002 0.5763415433144332 0.5763414534526424 8.937808995967966e-07 -0.0328678091037669 +0.2247 0.5763709374347402 0.5763708313031367 9.021402584685756e-07 -0.03288135853947051 +0.2248 0.5764003271956453 0.5764002046461916 9.103583988312458e-07 -0.032894906621663174 +0.22490000000000002 0.5764297125956833 0.576429573482796 9.184340022949655e-07 -0.03290845334992245 +0.225 0.5764590936333782 0.5764589378139506 9.263657714531082e-07 -0.03292199872382617 +0.22510000000000002 0.5764884703072425 0.5764882976406687 9.34152430492885e-07 -0.032935542742952316 +0.2252 0.5765178426157773 0.5765176529639748 9.417927253618785e-07 -0.03294908540687911 +0.2253 0.5765472105574735 0.5765470037849055 9.492854236847759e-07 -0.03296262671518496 +0.22540000000000002 0.5765765741308109 0.5765763501045086 9.566293155127692e-07 -0.03297616666744853 +0.2255 0.5766059333342589 0.5766056919238435 9.638232127961999e-07 -0.03298970526324864 +0.22560000000000002 0.5766352881662768 0.5766350292439805 9.70865950133959e-07 -0.03300324250216436 +0.2257 0.5766646386253138 0.5766643620660005 9.777563850787985e-07 -0.033016778383774946 +0.2258 0.5766939847098087 0.5766936903909955 9.8449339758222e-07 -0.03303031290765986 +0.22590000000000002 0.5767233264181912 0.5767230142200679 9.910758910214312e-07 -0.033043846073398796 +0.226 0.5767526637488812 0.5767523335543303 9.97502791755256e-07 -0.033057377880571635 +0.22610000000000002 0.5767819967002898 0.5767816483949053 1.0037730498457798e-06 -0.033070908328758496 +0.2262 0.5768113252708186 0.5768109587429257 1.0098856387807942e-06 -0.03308443741753967 +0.2263 0.57684064945886 0.5768402645995336 1.0158395557513522e-06 -0.033097965146495704 +0.22640000000000002 0.5768699692627983 0.5768695659658808 1.0216338219293242e-06 -0.03311149151520732 +0.2265 0.5768992846810093 0.5768988628431284 1.0272674826894423e-06 -0.03312501652325543 +0.22660000000000002 0.57692859571186 0.5769281552324462 1.032739607664812e-06 -0.03313854017022121 +0.2267 0.57695790235371 0.5769574431350136 1.0380492909134453e-06 -0.033152062455686034 +0.2268 0.5769872046049107 0.5769867265520177 1.0431956506407047e-06 -0.033165583379231436 +0.22690000000000002 0.577016502463806 0.5770160054846547 1.048177830753616e-06 -0.03317910294043924 +0.227 0.5770457959287325 0.5770452799341289 1.0529949989734888e-06 -0.03319262113889141 +0.22710000000000002 0.5770750849980192 0.5770745499016521 1.0576463486677845e-06 -0.033206137974170144 +0.2272 0.5771043696699887 0.5771038153884444 1.0621310981839827e-06 -0.03321965344585785 +0.2273 0.5771336499429564 0.5771330763957332 1.0664484913491812e-06 -0.03323316755353717 +0.22740000000000002 0.5771629258152313 0.5771623329247535 1.0705977971370295e-06 -0.03324668029679094 +0.2275 0.5771921972851164 0.5771915849767469 1.0745783102228401e-06 -0.033260191675202166 +0.22760000000000002 0.5772214643509079 0.5772208325529622 1.0783893509280773e-06 -0.03327370168835407 +0.2277 0.577250727010897 0.577250075654655 1.0820302652758684e-06 -0.0332872103358302 +0.2278 0.5772799852633685 0.5772793142830872 1.0855004252685596e-06 -0.03330071761721416 +0.22790000000000002 0.5773092391066027 0.5773085484395268 1.0887992291652715e-06 -0.0333142235320899 +0.228 0.5773384885388737 0.5773377781252479 1.0919261008712766e-06 -0.03332772808004144 +0.22810000000000002 0.5773677335584512 0.57736700334153 1.0948804911592447e-06 -0.03334123126065312 +0.22820000000000001 0.5773969741636003 0.5773962240896588 1.0976618765035084e-06 -0.03335473307350947 +0.2283 0.5774262103525811 0.5774254403709247 1.1002697603568201e-06 -0.033368233518195164 +0.2284 0.5774554421236501 0.5774546521866234 1.1027036723731953e-06 -0.033381732594295166 +0.2285 0.577484669475059 0.5774838595380554 1.1049631690185358e-06 -0.03339523030139461 +0.22860000000000003 0.5775138924050566 0.5775130624265259 1.1070478334040956e-06 -0.03340872663907889 +0.22870000000000001 0.5775431109118871 0.5775422608533443 1.1089572752864818e-06 -0.03342222160693351 +0.2288 0.5775723249937921 0.5775714548198239 1.1106911313452095e-06 -0.033435715204544275 +0.2289 0.5776015346490102 0.5776006443272825 1.1122490652937245e-06 -0.03344920743149717 +0.229 0.5776307398757765 0.5776298293770412 1.1136307678794033e-06 -0.03346269828737843 +0.22910000000000003 0.5776599406723242 0.5776590099704244 1.1148359566059973e-06 -0.03347618777177437 +0.22920000000000001 0.5776891370368835 0.5776881861087597 1.1158643763997667e-06 -0.03348967588427169 +0.2293 0.5777183289676829 0.577717357793378 1.1167157992764132e-06 -0.0335031626244572 +0.2294 0.5777475164629489 0.5777465250256125 1.1173900243965917e-06 -0.03351664799191794 +0.2295 0.5777766995209059 0.5777756878067991 1.1178868784544882e-06 -0.03353013198624113 +0.22960000000000003 0.5778058781397776 0.5778048461382757 1.1182062152337302e-06 -0.033543614607014265 +0.22970000000000002 0.5778350523177858 0.5778340000213825 1.1183479158294318e-06 -0.03355709585382501 +0.2298 0.577864222053152 0.5778631494574612 1.1183118888702381e-06 -0.03357057572626126 +0.2299 0.5778933873440966 0.5778922944478552 1.118098070407303e-06 -0.03358405422391111 +0.23 0.5779225481888395 0.5779214349939088 1.1177064239142886e-06 -0.033597531346362834 +0.23010000000000003 0.5779517045856004 0.5779505710969675 1.1171369403983888e-06 -0.03361100709320494 +0.23020000000000002 0.5779808565325992 0.5779797027583775 1.1163896381782834e-06 -0.03362448146402614 +0.2303 0.5780100040280564 0.5780088299794861 1.1154645632172056e-06 -0.03363795445841549 +0.2304 0.578039147070192 0.5780379527616403 1.1143617890119195e-06 -0.03365142607596199 +0.2305 0.5780682856572276 0.5780670711061873 1.113081416426187e-06 -0.033664896316255126 +0.23060000000000003 0.5780974197873854 0.5780961850144741 1.1116235739128122e-06 -0.0336783651788844 +0.23070000000000002 0.5781265494588889 0.5781252944878472 1.1099884174581298e-06 -0.03369183266343962 +0.2308 0.5781556746699632 0.5781543995276526 1.1081761306930282e-06 -0.03370529876951075 +0.2309 0.578184795418835 0.5781835001352353 1.1061869246153933e-06 -0.033718763496688016 +0.231 0.578213911703733 0.578212596311939 1.1040210376456194e-06 -0.033732226844561834 +0.23110000000000003 0.5782430235228879 0.5782416880591061 1.1016787356821212e-06 -0.03374568881272281 +0.23120000000000002 0.5782721308745331 0.5782707753780775 1.0991603120458215e-06 -0.033759149400761794 +0.2313 0.5783012337569046 0.5782998582701921 1.0964660875356635e-06 -0.03377260860826985 +0.2314 0.5783303321682413 0.5783289367367869 1.0935964102065654e-06 -0.03378606643483822 +0.2315 0.578359426106785 0.5783580107791957 1.0905516553694206e-06 -0.03379952288005836 +0.23160000000000003 0.5783885155707819 0.5783870803987505 1.0873322260906981e-06 -0.03381297794352199 +0.23170000000000002 0.5784176005584805 0.5784161455967805 1.0839385519711975e-06 -0.033826431624821005 +0.2318 0.5784466810681339 0.5784452063746113 1.0803710904228048e-06 -0.0338398839235475 +0.2319 0.5784757570979995 0.5784742627335653 1.0766303257803145e-06 -0.03385333483929378 +0.232 0.5785048286463383 0.5785033146749616 1.0727167692459183e-06 -0.03386678437165238 +0.23210000000000003 0.578533895711417 0.5785323622001153 1.0686309593332943e-06 -0.03388023252021602 +0.23220000000000002 0.5785629582915062 0.5785614053103373 1.0643734614235179e-06 -0.03389367928457768 +0.2323 0.5785920163848821 0.5785904440069343 1.059944867654039e-06 -0.03390712466433051 +0.2324 0.5786210699898262 0.5786194782912089 1.0553457970852165e-06 -0.03392056865906794 +0.2325 0.578650119104625 0.5786485081644582 1.05057689536725e-06 -0.033934011268383475 +0.23260000000000003 0.5786791637275717 0.5786775336279746 1.0456388348512036e-06 -0.03394745249187093 +0.23270000000000002 0.5787082038569649 0.5787065546830457 1.0405323145890044e-06 -0.033960892329124366 +0.2328 0.5787372394911096 0.578735571330953 1.03525805966731e-06 -0.03397433077973797 +0.2329 0.5787662706283173 0.5787645835729722 1.0298168219846637e-06 -0.03398776784330617 +0.233 0.5787952972669064 0.5787935914103739 1.0242093793633167e-06 -0.03400120351942362 +0.23310000000000003 0.578824319405202 0.5788225948444219 1.0184365360488279e-06 -0.03401463780768518 +0.23320000000000002 0.5788533370415365 0.5788515938763735 1.0124991219884194e-06 -0.0340280707076859 +0.2333 0.5788823501742499 0.5788805885074797 1.0063979932750655e-06 -0.0340415022190211 +0.2334 0.5789113588016899 0.5789095787389844 1.0001340317589147e-06 -0.034054932341286225 +0.2335 0.5789403629222116 0.5789385645721247 9.937081449917784e-07 -0.03406836107407702 +0.23360000000000003 0.5789693625341786 0.5789675460081298 9.871212661161088e-07 -0.034081788416989355 +0.23370000000000002 0.578998357635963 0.5789965230482219 9.803743536429543e-07 -0.034095214369619396 +0.2338 0.5790273482259449 0.5790254956936152 9.73468391340937e-07 -0.034108638931563476 +0.2339 0.5790563343025141 0.5790544639455159 9.664043880697193e-07 -0.03412206210241813 +0.234 0.5790853158640684 0.5790834278051219 9.591833779465375e-07 -0.03413548388178016 +0.23410000000000003 0.5791142929090156 0.5791123872736228 9.518064197910903e-07 -0.03414890426924647 +0.23420000000000002 0.5791432654357725 0.5791413423521995 9.44274597153294e-07 -0.03416232326441434 +0.2343 0.5791722334427659 0.5791702930420239 9.365890182855274e-07 -0.03417574086688109 +0.2344 0.5792011969284323 0.5791992393442588 9.287508155042534e-07 -0.03418915707624437 +0.2345 0.5792301558912185 0.5792281812600578 9.207611457451303e-07 -0.03420257189210201 +0.23460000000000003 0.5792591103295817 0.5792571187905647 9.126211895638114e-07 -0.03421598531405203 +0.23470000000000002 0.5792880602419891 0.5792860519369138 9.043321518575897e-07 -0.03422939734169269 +0.2348 0.5793170056269192 0.5793149807002295 8.958952611159976e-07 -0.03424280797462244 +0.2349 0.5793459464828615 0.5793439050816257 8.873117692820287e-07 -0.03425621721243998 +0.235 0.5793748828083164 0.5793728250822059 8.785829517243826e-07 -0.03426962505474415 +0.23510000000000003 0.5794038146017959 0.5794017407030632 8.697101071541979e-07 -0.03428303150113409 +0.23520000000000002 0.5794327418618234 0.57943065194528 8.606945571254521e-07 -0.03429643655120907 +0.2353 0.5794616645869344 0.5794595588099272 8.515376459239388e-07 -0.03430984020456865 +0.2354 0.5794905827756759 0.5794884612980651 8.422407406782906e-07 -0.034323242460812545 +0.2355 0.5795194964266078 0.579517359410742 8.328052307216005e-07 -0.034336643319540706 +0.23560000000000003 0.579548405538302 0.5795462531489949 8.232325277024444e-07 -0.034350042780353286 +0.23570000000000002 0.5795773101093432 0.5795751425138489 8.135240652518139e-07 -0.0343634408428507 +0.2358 0.5796062101383286 0.579604027506317 8.036812986778052e-07 -0.034376837506633444 +0.2359 0.5796351056238687 0.5796329081274001 7.937057051321528e-07 -0.0343902327713024 +0.236 0.579663996564587 0.5796617843780866 7.83598782805317e-07 -0.03440362663645852 +0.23610000000000003 0.5796928829591207 0.5796906562593527 7.733620512595518e-07 -0.034417019101703084 +0.23620000000000002 0.5797217648061201 0.5797195237721611 7.629970508182815e-07 -0.03443041016663748 +0.2363 0.5797506421042499 0.5797483869174618 7.525053425105899e-07 -0.03444379983086334 +0.2364 0.5797795148521881 0.5797772456961918 7.418885079324422e-07 -0.034457188093982585 +0.2365 0.5798083830486274 0.5798061001092748 7.31148148941374e-07 -0.03447057495559726 +0.23660000000000003 0.5798372466922743 0.5798349501576207 7.202858871568907e-07 -0.03448396041530962 +0.23670000000000002 0.5798661057818504 0.5798637958421257 7.093033640714896e-07 -0.034497344472722194 +0.2368 0.5798949603160912 0.5798926371636723 6.982022406343269e-07 -0.03451072712743769 +0.2369 0.579923810293748 0.579921474123129 6.869841970014168e-07 -0.034524108379059025 +0.237 0.5799526557135861 0.5799503067213497 6.756509324523652e-07 -0.03453748822718933 +0.23710000000000003 0.5799814965743869 0.5799791349591744 6.642041648630137e-07 -0.03455086667143196 +0.23720000000000002 0.5800103328749464 0.5800079588374278 6.526456306499284e-07 -0.03456424371139048 +0.2373 0.5800391646140769 0.5800367783569208 6.409770845761109e-07 -0.03457761934666866 +0.2374 0.5800679917906058 0.5800655935184484 6.292002991958867e-07 -0.03459099357687049 +0.2375 0.5800968144033766 0.5800944043227911 6.173170648549053e-07 -0.03460436640160016 +0.23760000000000003 0.5801256324512487 0.5801232107707142 6.053291892460511e-07 -0.034617737820462076 +0.23770000000000002 0.5801544459330978 0.5801520128629674 5.932384972429094e-07 -0.03463110783306089 +0.2378 0.5801832548478161 0.5801808106002848 5.810468307054784e-07 -0.034644476439001426 +0.2379 0.5802120591943118 0.5802096039833852 5.687560479805676e-07 -0.03465784363788875 +0.238 0.5802408589715101 0.580238393012971 5.563680237630209e-07 -0.0346712094293281 +0.23810000000000003 0.580269654178353 0.580267177689729 5.438846487904048e-07 -0.03468457381292496 +0.23820000000000002 0.580298444813799 0.58029595801433 5.31307829482186e-07 -0.03469793678828503 +0.2383 0.5803272308768244 0.580324733987428 5.186394878842204e-07 -0.034711298355014235 +0.2384 0.5803560123664221 0.5803535056096608 5.05881561002619e-07 -0.03472465851271866 +0.2385 0.5803847892816028 0.5803822728816497 4.930360008870149e-07 -0.03473801726100464 +0.23860000000000003 0.580413561621394 0.5804110358039993 4.801047742142295e-07 -0.034751374599478725 +0.23870000000000002 0.5804423293848414 0.5804397943772974 4.670898617331609e-07 -0.03476473052774768 +0.2388 0.5804710925710087 0.5804685486021149 4.539932582786621e-07 -0.034778085045418475 +0.2389 0.5804998511789765 0.5804972984790053 4.408169724523514e-07 -0.03479143815209828 +0.239 0.5805286052078443 0.5805260440085049 4.275630261507679e-07 -0.034804789847394484 +0.23910000000000003 0.5805573546567294 0.5805547851911332 4.142334542461823e-07 -0.03481814013091472 +0.23920000000000002 0.5805860995247673 0.5805835220273915 4.008303045449635e-07 -0.03483148900226677 +0.2393 0.5806148398111118 0.580612254517764 3.8735563719083377e-07 -0.03484483646105871 +0.2394 0.5806435755149354 0.5806409826627174 3.7381152437343523e-07 -0.03485818250689878 +0.2395 0.5806723066354291 0.5806697064627001 3.602000502450631e-07 -0.03487152713939545 +0.23960000000000004 0.5807010331718023 0.5806984259181426 3.4652331037943185e-07 -0.03488487035815737 +0.23970000000000002 0.5807297551232837 0.5807271410294581 3.3278341156350866e-07 -0.03489821216279345 +0.2398 0.5807584724891205 0.5807558517970406 3.1898247135342395e-07 -0.03491155255291278 +0.2399 0.5807871852685791 0.5807845582212668 3.051226178663047e-07 -0.03492489152812469 +0.24 0.5808158934609448 0.5808132603024948 2.912059893778185e-07 -0.034938229088038696 +0.24010000000000004 0.5808445970655225 0.5808419580410641 2.7723473414176247e-07 -0.03495156523226455 +0.24020000000000002 0.5808732960816361 0.5808706514372955 2.632110098210738e-07 -0.03496489996041221 +0.2403 0.5809019905086289 0.5808993404914922 2.491369833629298e-07 -0.03497823327209184 +0.2404 0.5809306803458634 0.5809280252039375 2.3501483051302507e-07 -0.03499156516691383 +0.2405 0.5809593655927222 0.580956705574897 2.2084673562128287e-07 -0.035004895644488776 +0.24060000000000004 0.580988046248607 0.5809853816046164 2.066348911561322e-07 -0.03501822470442747 +0.24070000000000003 0.5810167223129397 0.5810140532933237 1.9238149752409672e-07 -0.035031552346340984 +0.24080000000000001 0.5810453937851614 0.5810427206412266 1.780887626187666e-07 -0.0350448785698405 +0.2409 0.5810740606647333 0.5810713836485147 1.63758901529365e-07 -0.0350582033745375 +0.241 0.5811027229511369 0.5811000423153583 1.4939413615217e-07 -0.03507152676004365 +0.24110000000000004 0.581131380643873 0.5811286966419082 1.3499669487132548e-07 -0.03508484872597084 +0.24120000000000003 0.5811600337424628 0.5811573466282962 1.205688122327131e-07 -0.03509816927193112 +0.24130000000000001 0.5811886822464477 0.5811859922746344 1.0611272861782428e-07 -0.035111488397536826 +0.2414 0.581217326155389 0.5812146335810162 9.163068979967104e-08 -0.03512480610240048 +0.2415 0.5812459654688684 0.5812432705475153 7.712494666523018e-08 -0.035138122386134805 +0.2416 0.5812746001864878 0.5812719031741855 6.25977548823764e-08 -0.03515143724835278 +0.24170000000000003 0.5813032303078692 0.5813005314610615 4.805137450436536e-08 -0.03516475068866751 +0.24180000000000001 0.5813318558326552 0.5813291554081585 3.3488069640236207e-08 -0.03517806270669243 +0.2419 0.5813604767605086 0.5813577750154719 1.891010811133631e-08 -0.035191373302041085 +0.242 0.5813890930911129 0.5813863902829774 4.3197610696821265e-09 -0.035204682474327294 +0.2421 0.5814177048241717 0.5814150012106314 -1.0280697343781342e-08 -0.03521799022316509 +0.24220000000000003 0.5814463119594093 0.5814436077983701 -2.488899033224745e-08 -0.03523129654816869 +0.24230000000000002 0.5814749144965708 0.5814722100461103 -3.9502838827289166e-08 -0.035244601448952556 +0.2424 0.5815035124354211 0.5815008079537488 -5.411996182984064e-08 -0.03525790492513132 +0.2425 0.5815321057757462 0.5815294015211627 -6.873807677438074e-08 -0.035271206976319865 +0.2426 0.5815606945173527 0.5815579907482097 -8.335489987999767e-08 -0.035284507602133294 +0.24270000000000003 0.5815892786600674 0.5815865756347272 -9.796814651012731e-08 -0.03529780680218688 +0.24280000000000002 0.5816178582037382 0.5816151561805327 -1.125755315304483e-07 -0.035311104576096174 +0.2429 0.5816464331482332 0.5816437323854242 -1.2717476966656038e-07 -0.03532440092347688 +0.243 0.5816750034934415 0.5816723042491799 -1.417635758609037e-07 -0.03533769584394495 +0.2431 0.5817035692392724 0.5817008717715578 -1.5633966561623414e-07 -0.03535098933711652 +0.24320000000000003 0.5817321303856561 0.5817294349522962 -1.7090075540848737e-07 -0.03536428140260799 +0.24330000000000002 0.5817606869325435 0.5817579937911138 -1.8544456297994727e-07 -0.035377572040035936 +0.2434 0.5817892388799056 0.5817865482877091 -1.9996880772782388e-07 -0.035390861249017164 +0.2435 0.5818177862277351 0.5818150984417614 -2.144712110546676e-07 -0.035404149029168684 +0.2436 0.5818463289760439 0.581843644252929 -2.289494967500083e-07 -0.03541743538010774 +0.24370000000000003 0.5818748671248655 0.5818721857208516 -2.434013913060751e-07 -0.035430720301451744 +0.24380000000000002 0.5819034006742534 0.5819007228451487 -2.5782462433759923e-07 -0.035444003792818375 +0.2439 0.5819319296242818 0.5819292556254198 -2.722169288871257e-07 -0.03545728585382548 +0.244 0.5819604539750455 0.581957784061245 -2.865760417788965e-07 -0.035470566484091165 +0.2441 0.5819889737266597 0.5819863081521847 -3.0089970397967347e-07 -0.03548384568323374 +0.24420000000000003 0.58201748887926 0.5820148278977791 -3.1518566108446056e-07 -0.03549712345087169 +0.24430000000000002 0.5820459994330027 0.5820433432975499 -3.294316634205874e-07 -0.035510399786623785 +0.2444 0.582074505388064 0.582071854350998 -3.43635466651393e-07 -0.03552367469010893 +0.2445 0.5821030067446408 0.5821003610576053 -3.577948319288815e-07 -0.03553694816094632 +0.2446 0.5821315035029498 0.5821288634168342 -3.719075264557725e-07 -0.03555022019875528 +0.24470000000000003 0.5821599956632286 0.5821573614281278 -3.85971323624279e-07 -0.03556349080315542 +0.24480000000000002 0.5821884832257347 0.5821858550909095 -3.999840035295854e-07 -0.03557675997376655 +0.2449 0.5822169661907454 0.5822143444045834 -4.139433532196479e-07 -0.03559002771020868 +0.245 0.5822454445585583 0.5822428293685344 -4.2784716720867255e-07 -0.035603294012102035 +0.2451 0.5822739183294913 0.5822713099821282 -4.4169324756038186e-07 -0.035616558879067055 +0.24520000000000003 0.5823023875038816 0.5822997862447111 -4.554794044570043e-07 -0.03562982231072441 +0.24530000000000002 0.5823308520820873 0.5823282581556105 -4.6920345656009665e-07 -0.03564308430669496 +0.2454 0.5823593120644851 0.5823567257141349 -4.828632311076886e-07 -0.03565634486659982 +0.2455 0.5823877674514725 0.5823851889195735 -4.964565645249053e-07 -0.03566960399006027 +0.2456 0.5824162182434656 0.582413647771197 -5.099813026876454e-07 -0.03568286167669783 +0.24570000000000003 0.5824446644409009 0.5824421022682567 -5.234353012834037e-07 -0.03569611792613424 +0.24580000000000002 0.5824731060442343 0.5824705524099858 -5.368164260749486e-07 -0.03570937273799143 +0.2459 0.5825015430539409 0.5824989981955987 -5.501225531362453e-07 -0.03572262611189158 +0.246 0.5825299754705149 0.5825274396242913 -5.633515696851221e-07 -0.03573587804745708 +0.2461 0.5825584032944703 0.5825558766952408 -5.765013738612268e-07 -0.035749128544310484 +0.24620000000000003 0.5825868265263399 0.582584309407606 -5.895698753366485e-07 -0.03576237760207461 +0.24630000000000002 0.5826152451666755 0.5826127377605278 -6.025549955379628e-07 -0.0357756252203725 +0.2464 0.5826436592160479 0.5826411617531285 -6.154546681180761e-07 -0.03578887139882735 +0.2465 0.5826720686750464 0.5826695813845131 -6.282668391088819e-07 -0.03580211613706262 +0.2466 0.5827004735442799 0.5826979966537676 -6.409894675318828e-07 -0.03581535943470198 +0.24670000000000003 0.5827288738243751 0.5827264075599614 -6.536205253704352e-07 -0.03582860129136935 +0.24680000000000002 0.5827572695159777 0.5827548141021451 -6.66157998263639e-07 -0.03584184170668878 +0.2469 0.5827856606197515 0.5827832162793518 -6.785998853953146e-07 -0.03585508068028458 +0.247 0.5828140471363784 0.5828116140905978 -6.909442002711597e-07 -0.03586831821178129 +0.24710000000000001 0.5828424290665589 0.5828400075348814 -7.031889706354821e-07 -0.035881554300803635 +0.24720000000000003 0.5828708064110112 0.5828683966111838 -7.153322392206007e-07 -0.035894788946976564 +0.24730000000000002 0.5828991791704715 0.5828967813184692 -7.27372063746845e-07 -0.03590802214992527 +0.2474 0.5829275473456941 0.582925161655685 -7.393065170335777e-07 -0.03592125390927512 +0.2475 0.5829559109374503 0.5829535376217609 -7.511336880539066e-07 -0.035934484224651723 +0.24760000000000001 0.582984269946529 0.582981909215611 -7.628516815738617e-07 -0.03594771309568088 +0.2477 0.583012624373737 0.583010276436132 -7.744586185964852e-07 -0.03596094052198864 +0.24780000000000002 0.583040974219898 0.5830386392822046 -7.859526368614311e-07 -0.03597416650320121 +0.2479 0.5830693194858525 0.5830669977526929 -7.973318907894544e-07 -0.035987391038945084 +0.248 0.5830976601724582 0.5830953518464448 -8.085945524816118e-07 -0.03600061412884692 +0.24810000000000001 0.5831259962805899 0.5831237015622925 -8.197388110253723e-07 -0.03601383577253361 +0.2482 0.5831543278111386 0.5831520468990523 -8.307628737713735e-07 -0.03602705596963226 +0.24830000000000002 0.5831826547650116 0.5831803878555247 -8.416649658615771e-07 -0.03604027471977019 +0.2484 0.5832109771431329 0.5832087244304947 -8.524433308954027e-07 -0.03605349202257493 +0.2485 0.5832392949464426 0.5832370566227316 -8.630962312905499e-07 -0.03606670787767422 +0.24860000000000002 0.5832676081758965 0.5832653844309899 -8.736219483940211e-07 -0.036079922284696045 +0.2487 0.5832959168324667 0.5832937078540091 -8.840187826486545e-07 -0.03609313524326856 +0.24880000000000002 0.5833242209171406 0.5833220268905136 -8.942850541204805e-07 -0.03610634675302021 +0.2489 0.5833525204309213 0.583350341539213 -9.044191026374993e-07 -0.036119556813579555 +0.249 0.583380815374827 0.5833786517988023 -9.144192882615254e-07 -0.03613276542457544 +0.24910000000000002 0.5834091057498911 0.5834069576679625 -9.242839910938994e-07 -0.03614597258563689 +0.2492 0.5834373915571622 0.5834352591453601 -9.340116121081543e-07 -0.03615917829639318 +0.24930000000000002 0.5834656727977034 0.5834635562296479 -9.436005729834829e-07 -0.03617238255647378 +0.2494 0.5834939494725924 0.583491848919464 -9.530493167708709e-07 -0.036185585365508345 +0.2495 0.5835222215829217 0.5835201372134343 -9.62356307532275e-07 -0.03619878672312681 +0.24960000000000002 0.5835504891297972 0.58354842111017 -9.715200314230898e-07 -0.03621198662895926 +0.2497 0.5835787521143401 0.5835767006082696 -9.805389959705035e-07 -0.03622518508263606 +0.24980000000000002 0.5836070105376844 0.5836049757063184 -9.894117312947426e-07 -0.03623838208378776 +0.2499 0.5836352644009779 0.5836332464028886 -9.981367898037607e-07 -0.03625157763204508 +0.25 0.5836635137053824 0.5836615126965403 -1.006712746332017e-06 -0.03626477172703906 +0.25010000000000004 0.5836917584520724 0.5836897745858206 -1.0151381987788533e-06 -0.03627796436840086 +0.25020000000000003 0.5837199986422358 0.5837180320692644 -1.0234117681084953e-06 -0.036291155555761866 +0.2503 0.5837482342770732 0.5837462851453947 -1.0315320984888299e-06 -0.03630434528875377 +0.2504 0.5837764653577979 0.5837745338127224 -1.0394978577077385e-06 -0.03631753356700838 +0.2505 0.5838046918856358 0.5838027780697468 -1.0473077373951423e-06 -0.036330720390157736 +0.25060000000000004 0.5838329138618246 0.5838310179149555 -1.054960453328313e-06 -0.0363439057578341 +0.25070000000000003 0.5838611312876141 0.5838592533468253 -1.0624547450155397e-06 -0.03635708966966996 +0.2508 0.5838893441642666 0.5838874843638218 -1.0697893769451294e-06 -0.03637027212529807 +0.2509 0.5839175524930553 0.5839157109643996 -1.0769631378360067e-06 -0.03638345312435131 +0.251 0.5839457562752648 0.5839439331470028 -1.0839748411928252e-06 -0.03639663266646279 +0.25110000000000005 0.5839739555121914 0.5839721509100652 -1.0908233260276123e-06 -0.036409810751265904 +0.25120000000000003 0.5840021502051419 0.5840003642520104 -1.097507456193636e-06 -0.03642298737839422 +0.2513 0.5840303403554338 0.5840285731712517 -1.1040261211348046e-06 -0.03643616254748148 +0.2514 0.5840585259643952 0.584056777666193 -1.1103782359134229e-06 -0.03644933625816169 +0.2515 0.5840867070333644 0.5840849777352286 -1.116562741265703e-06 -0.036462508510069054 +0.25160000000000005 0.5841148835636899 0.5841131733767437 -1.1225786040180985e-06 -0.03647567930283802 +0.25170000000000003 0.58414305555673 0.5841413645891143 -1.1284248170873035e-06 -0.03648884863610321 +0.2518 0.5841712230138527 0.5841695513707075 -1.1341004001463872e-06 -0.036502016509499524 +0.2519 0.5841993859364351 0.584197733719882 -1.1396043986255933e-06 -0.036515182922662 +0.252 0.5842275443258633 0.5842259116349882 -1.144935885100118e-06 -0.03652834787522596 +0.25210000000000005 0.5842556981835325 0.584254085114368 -1.150093959123577e-06 -0.03654151136682684 +0.25220000000000004 0.5842838475108464 0.5842822541563557 -1.1550777465618722e-06 -0.03655467339710041 +0.2523 0.5843119923092174 0.5843104187592778 -1.1598864013140364e-06 -0.03656783396568257 +0.2524 0.5843401325800661 0.5843385789214541 -1.1645191039244551e-06 -0.036580993072209564 +0.2525 0.5843682683248204 0.5843667346411962 -1.1689750626930895e-06 -0.03659415071631764 +0.25260000000000005 0.5843963995449165 0.5843948859168094 -1.173253513175876e-06 -0.03660730689764348 +0.25270000000000004 0.584424526241798 0.5844230327465924 -1.1773537190173933e-06 -0.03662046161582385 +0.2528 0.5844526484169152 0.584451175128837 -1.1812749714512627e-06 -0.03663361487049576 +0.2529 0.5844807660717262 0.5844793130618292 -1.185016589855259e-06 -0.03664676666129648 +0.253 0.5845088792076948 0.5845074465438489 -1.1885779214737546e-06 -0.03665991698786341 +0.25310000000000005 0.5845369878262918 0.58453557557317 -1.1919583419173208e-06 -0.0366730658498342 +0.25320000000000004 0.5845650919289941 0.584563700148062 -1.1951572551072154e-06 -0.03668621324684675 +0.2533 0.5845931915172846 0.584591820266788 -1.1981740934419172e-06 -0.03669935917853916 +0.2534 0.5846212865926521 0.5846199359276072 -1.2010083177971254e-06 -0.03671250364454975 +0.2535 0.5846493771565906 0.584648047128773 -1.2036594176922932e-06 -0.03672564664451705 +0.25360000000000005 0.5846774632105993 0.5846761538685356 -1.206126911235117e-06 -0.0367387881780798 +0.25370000000000004 0.584705544756182 0.58470425614514 -1.2084103457321582e-06 -0.03675192824487692 +0.2538 0.584733621794848 0.584732353956828 -1.2105092970782216e-06 -0.03676506684454764 +0.2539 0.5847616943281102 0.5847604473018375 -1.212423370255955e-06 -0.03677820397673135 +0.254 0.5847897623574865 0.5847885361784027 -1.2141521992803384e-06 -0.03679133964106763 +0.25410000000000005 0.5848178258844976 0.5848166205847551 -1.2156954475872617e-06 -0.036804473837196296 +0.25420000000000004 0.5848458849106688 0.5848447005191231 -1.2170528075339249e-06 -0.036817606564757396 +0.2543 0.5848739394375285 0.5848727759797323 -1.2182240008429268e-06 -0.03683073782339117 +0.2544 0.5849019894666083 0.5849008469648065 -1.219208778491243e-06 -0.03684386761273813 +0.2545 0.5849300349994424 0.5849289134725667 -1.220006921098804e-06 -0.03685699593243894 +0.25460000000000005 0.5849580760375679 0.5849569755012326 -1.2206182385954278e-06 -0.03687012278213451 +0.25470000000000004 0.5849861125825239 0.584985033049022 -1.2210425703318428e-06 -0.036883248161465945 +0.2548 0.585014144635852 0.5850130861141516 -1.221279785301732e-06 -0.03689637207007459 +0.2549 0.5850421721990953 0.5850411346948367 -1.2213297821417335e-06 -0.036909494507601975 +0.255 0.5850701952737987 0.5850691787892923 -1.2211924886318393e-06 -0.03692261547368993 +0.25510000000000005 0.5850982138615083 0.5850972183957325 -1.220867862750108e-06 -0.03693573496798037 +0.25520000000000004 0.585126227963771 0.5851252535123712 -1.2203558920620416e-06 -0.03694885299011552 +0.2553 0.5851542375821351 0.5851532841374221 -1.2196565933875192e-06 -0.03696196953973779 +0.2554 0.5851822427181488 0.5851813102690999 -1.2187700136889745e-06 -0.03697508461648986 +0.2555 0.5852102433733606 0.5852093319056189 -1.2176962291277071e-06 -0.0369881982200145 +0.25560000000000005 0.5852382395493189 0.5852373490451948 -1.2164353462296162e-06 -0.03700131034995481 +0.25570000000000004 0.5852662312475723 0.5852653616860444 -1.2149875006084443e-06 -0.0370144210059541 +0.2558 0.5852942184696682 0.5852933698263849 -1.2133528579649777e-06 -0.03702753018765579 +0.2559 0.585322201217154 0.5853213734644367 -1.2115316135319354e-06 -0.03704063789470368 +0.256 0.5853501794915753 0.5853493725984202 -1.2095239920184575e-06 -0.037053744126741665 +0.25610000000000005 0.5853781532944766 0.5853773672265593 -1.207330248165217e-06 -0.03706684888341388 +0.2562 0.5854061226274008 0.5854053573470799 -1.204950666078286e-06 -0.03707995216436469 +0.25630000000000003 0.5854340874918885 0.5854333429582101 -1.2023855593401578e-06 -0.03709305396923868 +0.2564 0.5854620478894792 0.5854613240581816 -1.1996352713428138e-06 -0.03710615429768064 +0.2565 0.5854900038217088 0.5854893006452289 -1.1967001749546569e-06 -0.03711925314933561 +0.25660000000000005 0.5855179552901111 0.5855172727175897 -1.193580672465e-06 -0.037132350523848806 +0.2567 0.5855459022962172 0.585545240273506 -1.1902771955285552e-06 -0.037145446420865647 +0.25680000000000003 0.5855738448415544 0.5855732033112232 -1.1867902053319668e-06 -0.037158540840031784 +0.2569 0.5856017829276471 0.5856011618289911 -1.1831201921497225e-06 -0.037171633780993134 +0.257 0.5856297165560154 0.5856291158250643 -1.1792676757327314e-06 -0.03718472524339577 +0.2571 0.585657645728176 0.5856570652977017 -1.1752332049197456e-06 -0.03719781522688601 +0.2572 0.5856855704456411 0.5856850102451672 -1.1710173576928717e-06 -0.03721090373111035 +0.25730000000000003 0.5857134907099184 0.5857129506657304 -1.1666207409555263e-06 -0.03722399075571557 +0.2574 0.5857414065225107 0.5857408865576661 -1.162043990809991e-06 -0.03723707630034862 +0.2575 0.5857693178849158 0.5857688179192548 -1.1572877719467911e-06 -0.03725016036465664 +0.2576 0.5857972247986267 0.5857967447487835 -1.1523527778667386e-06 -0.03726324294828706 +0.2577 0.58582512726513 0.5858246670445453 -1.1472397309364446e-06 -0.037276324050887495 +0.25780000000000003 0.5858530252859072 0.5858525848048393 -1.141949382166274e-06 -0.037289403672105745 +0.2579 0.5858809188624334 0.5858804980279722 -1.136482510821768e-06 -0.03730248181158986 +0.258 0.5859088079961776 0.5859084067122576 -1.1308399244791545e-06 -0.037315558468988104 +0.2581 0.5859366926886019 0.5859363108560162 -1.1250224591918823e-06 -0.03732863364394893 +0.2582 0.5859645729411621 0.5859642104575763 -1.1190309791020425e-06 -0.03734170733612104 +0.25830000000000003 0.5859924487553063 0.5859921055152741 -1.1128663763848579e-06 -0.03735477954515336 +0.2584 0.586020320132476 0.5860199960274539 -1.1065295710821488e-06 -0.037367850270694995 +0.2585 0.5860481870741043 0.5860478819924685 -1.100021510880289e-06 -0.037380919512395284 +0.2586 0.5860760495816171 0.5860757634086787 -1.0933431711657171e-06 -0.03739398726990376 +0.2587 0.5861039076564318 0.5861036402744548 -1.0864955548306465e-06 -0.03740705354287023 +0.25880000000000003 0.586131761299958 0.5861315125881761 -1.0794796921342886e-06 -0.03742011833094468 +0.2589 0.5861596105135963 0.5861593803482307 -1.0722966405085632e-06 -0.03743318163377731 +0.259 0.5861874552987387 0.5861872435530168 -1.0649474842805429e-06 -0.03744624345101854 +0.2591 0.5862152956567679 0.5862151022009423 -1.0574333349222531e-06 -0.03745930378231903 +0.2592 0.5862431315890575 0.5862429562904248 -1.0497553304400498e-06 -0.037472362627329586 +0.25930000000000003 0.5862709630969716 0.5862708058198928 -1.0419146352080855e-06 -0.037485419985701346 +0.2594 0.5862987901818644 0.5862986507877848 -1.0339124402458655e-06 -0.03749847585708556 +0.2595 0.5863266128450801 0.5863264911925501 -1.025749962801914e-06 -0.03751153024113374 +0.2596 0.5863544310879529 0.5863543270326497 -1.0174284459374405e-06 -0.03752458313749763 +0.2597 0.5863822449118063 0.5863821583065548 -1.008949158581851e-06 -0.037537634545829146 +0.25980000000000003 0.5864100543179529 0.586409985012749 -1.0003133955049925e-06 -0.03755068446578044 +0.2599 0.5864378593076944 0.5864378071497269 -9.9152247670653e-07 -0.037563732897003904 +0.26 0.5864656598823218 0.5864656247159956 -9.825777475824804e-07 -0.03757677983915211 +0.2601 0.5864934560431143 0.5864934377100738 -9.734805783701006e-07 -0.037589825291877876 +0.2602 0.5865212477913394 0.586521246130493 -9.642323642866657e-07 -0.037602869254834206 +0.26030000000000003 0.586549035128253 0.5865490499757974 -9.548345253351798e-07 -0.037615911727674374 +0.2604 0.5865768180550986 0.5865768492445436 -9.452885056659976e-07 -0.03762895271005184 +0.2605 0.5866045965731078 0.5866046439353015 -9.355957739376475e-07 -0.03764199220162023 +0.2606 0.5866323706834993 0.5866324340466544 -9.257578224841634e-07 -0.03765503020203345 +0.2607 0.5866601403874793 0.5866602195771989 -9.157761675926412e-07 -0.03766806671094565 +0.26080000000000003 0.586687905686241 0.5866880005255453 -9.056523490036383e-07 -0.037681101728011104 +0.2609 0.5867156665809643 0.5867157768903177 -8.953879297723955e-07 -0.03769413525288437 +0.261 0.5867434230728161 0.5867435486701548 -8.849844960745479e-07 -0.037707167285220215 +0.2611 0.5867711751629494 0.5867713158637092 -8.744436568175473e-07 -0.03772019782467361 +0.2612 0.5867989228525035 0.5867990784696484 -8.637670435573952e-07 -0.03773322687089974 +0.26130000000000003 0.5868266661426036 0.5868268364866539 -8.529563101100646e-07 -0.037746254423554 +0.2614 0.5868544050343605 0.586854589913423 -8.420131323849667e-07 -0.03775928048229202 +0.2615 0.5868821395288712 0.5868823387486679 -8.309392080796396e-07 -0.03777230504676965 +0.2616 0.5869098696272177 0.5869100829911161 -8.197362564854593e-07 -0.03778532811664295 +0.2617 0.5869375953304674 0.5869378226395106 -8.084060181268171e-07 -0.0377983496915682 +0.26180000000000003 0.5869653166396724 0.5869655576926099 -7.96950254733364e-07 -0.037811369771201864 +0.2619 0.5869930335558702 0.586993288149189 -7.85370748573877e-07 -0.037824388355200696 +0.262 0.5870207460800821 0.5870210140080389 -7.736693025672814e-07 -0.037837405443221596 +0.2621 0.5870484542133146 0.5870487352679663 -7.61847739672028e-07 -0.0378504210349217 +0.2622 0.5870761579565581 0.5870764519277949 -7.499079029416045e-07 -0.03786343512995836 +0.26230000000000003 0.5871038573107874 0.5871041639863651 -7.37851654941668e-07 -0.0378764477279892 +0.2624 0.5871315522769609 0.5871318714425338 -7.256808776667789e-07 -0.03788945882867198 +0.2625 0.5871592428560205 0.5871595742951752 -7.133974721795777e-07 -0.0379024684316647 +0.2626 0.5871869290488922 0.5871872725431807 -7.010033583054742e-07 -0.0379154765366256 +0.2627 0.5872146108564853 0.5872149661854591 -6.885004742718248e-07 -0.03792848314321312 +0.26280000000000003 0.5872422882796919 0.5872426552209367 -6.758907765413991e-07 -0.03794148825108597 +0.2629 0.5872699613193874 0.5872703396485572 -6.631762393682905e-07 -0.03795449185990296 +0.263 0.5872976299764301 0.5872980194672826 -6.503588547424055e-07 -0.03796749396932322 +0.2631 0.5873252942516611 0.5873256946760925 -6.374406316678183e-07 -0.03798049457900605 +0.2632 0.5873529541459042 0.5873533652739855 -6.244235963015488e-07 -0.037993493688611005 +0.26330000000000003 0.587380609659965 0.5873810312599773 -6.113097912874288e-07 -0.038006491297797804 +0.2634 0.5874082607946318 0.5874086926331032 -5.981012757283466e-07 -0.038019487406226425 +0.2635 0.5874359075506752 0.5874363493924164 -5.848001245201129e-07 -0.03803248201355702 +0.2636 0.5874635499288473 0.5874640015369892 -5.714084283514609e-07 -0.038045475119450015 +0.2637 0.5874911879298821 0.5874916490659128 -5.579282932877128e-07 -0.038058466723566 +0.26380000000000003 0.5875188215544958 0.5875192919782978 -5.443618403822015e-07 -0.03807145682556584 +0.2639 0.5875464508033855 0.5875469302732733 -5.307112051627927e-07 -0.038084445425110566 +0.264 0.5875740756772304 0.5875745639499885 -5.169785377151515e-07 -0.03809743252186146 +0.2641 0.5876016961766901 0.5876021930076114 -5.031660021276307e-07 -0.03811041811547999 +0.2642 0.5876293123024058 0.5876298174453303 -4.892757760888156e-07 -0.038123402205627856 +0.26430000000000003 0.5876569240549998 0.5876574372623524 -4.753100506377228e-07 -0.03813638479196697 +0.2644 0.5876845314350752 0.5876850524579056 -4.6127102980297874e-07 -0.03814936587415947 +0.2645 0.5877121344432159 0.587712663031237 -4.471609300893409e-07 -0.038162345451867724 +0.2646 0.5877397330799864 0.5877402689816147 -4.329819805470869e-07 -0.03817532352475429 +0.2647 0.5877673273459317 0.587767870308326 -4.187364221058809e-07 -0.03818830009248195 +0.26480000000000004 0.5877949172415773 0.5877954670106793 -4.044265072278286e-07 -0.03820127515471369 +0.2649 0.5878225027674291 0.5878230590880029 -3.9005449953277704e-07 -0.03821424871111277 +0.265 0.587850083923973 0.5878506465396461 -3.756226735762702e-07 -0.038227220761342606 +0.2651 0.5878776607116754 0.5878782293649784 -3.611333145026041e-07 -0.03824019130506683 +0.2652 0.587905233130982 0.5879058075633903 -3.4658871754522647e-07 -0.03825316034194934 +0.26530000000000004 0.5879328011823195 0.5879333811342928 -3.3199118769366986e-07 -0.038266127871654225 +0.2654 0.5879603648660936 0.5879609500771183 -3.1734303940211817e-07 -0.03827909389384579 +0.2655 0.5879879241826902 0.58798851439132 -3.0264659629797297e-07 -0.038292058408188556 +0.2656 0.5880154791324744 0.5880160740763719 -2.879041905295976e-07 -0.03830502141434726 +0.2657 0.588043029715791 0.5880436291317699 -2.731181626344781e-07 -0.03831798291198687 +0.26580000000000004 0.5880705759329647 0.5880711795570299 -2.5829086114370625e-07 -0.03833094290077253 +0.2659 0.5880981177842991 0.5880987253516904 -2.434246421309516e-07 -0.03834390138036967 +0.266 0.5881256552700775 0.5881262665153106 -2.285218689002111e-07 -0.03835685835044387 +0.2661 0.5881531883905625 0.5881538030474713 -2.1358491155559767e-07 -0.03836981381066097 +0.2662 0.5881807171459955 0.588181334947775 -1.986161467168457e-07 -0.03838276776068701 +0.26630000000000004 0.5882082415365978 0.5882088622158457 -1.8361795700583272e-07 -0.038395720200188256 +0.2664 0.588235761562569 0.5882363848513289 -1.6859273087310722e-07 -0.03840867112883119 +0.2665 0.5882632772240881 0.5882639028538917 -1.535428619386936e-07 -0.03842162054628248 +0.2666 0.5882907885213132 0.5882914162232238 -1.3847074888106992e-07 -0.03843456845220908 +0.2667 0.5883182954543812 0.5883189249590354 -1.2337879486470915e-07 -0.03844751484627808 +0.26680000000000004 0.5883457980234079 0.5883464290610595 -1.0826940725905398e-07 -0.038460459728156864 +0.2669 0.5883732962284878 0.5883739285290508 -9.31449972464693e-08 -0.03847340309751296 +0.267 0.5884007900696946 0.5884014233627858 -7.80079793660099e-08 -0.03848634495401418 +0.2671 0.5884282795470803 0.5884289135620628 -6.286077122198697e-08 -0.03849928529732849 +0.2672 0.5884557646606764 0.5884563991267028 -4.770579303380734e-08 -0.03851222412712415 +0.26730000000000004 0.588483245410492 0.588483880056548 -3.254546727254892e-08 -0.038525161443069555 +0.2674 0.588510721796516 0.5885113563514628 -1.7382218270864738e-08 -0.03853809724483338 +0.2675 0.5885381938187153 0.5885388280113342 -2.2184718302849238e-09 -0.03855103153208449 +0.2676 0.5885656614770357 0.5885662950360708 1.2943345159555086e-08 -0.03856396430449196 +0.2677 0.5885931247714016 0.5885937574256035 2.810080511686519e-08 -0.03857689556172508 +0.26780000000000004 0.588620583701716 0.5886212151798852 4.3251480149122945e-08 -0.038589825303453416 +0.2679 0.5886480382678605 0.5886486682988907 5.83929424501084e-08 -0.03860275352934667 +0.268 0.5886754884696955 0.5886761167826176 7.352276469585473e-08 -0.03861568023907479 +0.2681 0.58870293430706 0.5887035606310848 8.863852039853182e-08 -0.03862860543230794 +0.2682 0.5887303757797712 0.588730999844334 1.037377843592091e-07 -0.038641529108716544 +0.26830000000000004 0.5887578128876256 0.5887584344224286 1.1881813298877941e-07 -0.038654451267971186 +0.2684 0.588785245630398 0.5887858643654542 1.3387714474510926e-07 -0.038667371909742704 +0.2685 0.5888126740078417 0.5888132896735188 1.489124005354947e-07 -0.03868029103370213 +0.2686 0.5888400980196891 0.5888407103467519 1.6392148405319773e-07 -0.03869320863952075 +0.2687 0.5888675176656506 0.5888681263853054 1.7890198217990205e-07 -0.038706124726869996 +0.26880000000000004 0.5888949329454161 0.588895537789353 1.93851485419394e-07 -0.03871903929542158 +0.26890000000000003 0.5889223438586538 0.5889229445590909 2.0876758826532393e-07 -0.03873195234484743 +0.269 0.5889497504050109 0.5889503466947367 2.2364788952039527e-07 -0.038744863874819645 +0.2691 0.5889771525841131 0.58897774419653 2.384899928237205e-07 -0.038757773885010595 +0.2692 0.5890045503955653 0.5890051370647327 2.5329150687286583e-07 -0.03877068237509283 +0.2693 0.5890319438389511 0.5890325252996281 2.680500459928403e-07 -0.03878358934473913 +0.26940000000000003 0.5890593329138331 0.5890599089015215 2.8276323035814066e-07 -0.0387964947936225 +0.2695 0.589086717619753 0.58908728787074 2.9742868647153475e-07 -0.038809398721416165 +0.2696 0.589114097956231 0.5891146622076323 3.1204404749018977e-07 -0.038822301127793536 +0.2697 0.5891414739227673 0.5891420319125688 3.266069537044558e-07 -0.03883520201242827 +0.2698 0.5891688455188405 0.5891693969859413 3.411150528431772e-07 -0.038848101374994254 +0.26990000000000003 0.5891962127439088 0.5891967574281634 3.555660003928818e-07 -0.03886099921516555 +0.27 0.5892235755974095 0.5892241132396698 3.6995746022228104e-07 -0.03887389553261646 +0.2701 0.5892509340787592 0.589251464420917 3.8428710459614823e-07 -0.038886790327021525 +0.2702 0.5892782881873544 0.5892788109723828 3.9855261491084093e-07 -0.03889968359805546 +0.2703 0.5893056379225704 0.5893061528945658 4.1275168188859013e-07 -0.03891257534539322 +0.27040000000000003 0.5893329832837627 0.5893334901879861 4.268820059660783e-07 -0.03892546556870999 +0.2705 0.5893603242702662 0.5893608228531848 4.4094129758587286e-07 -0.03893835426768116 +0.2706 0.5893876608813955 0.589388150890724 4.549272777931712e-07 -0.038951241441982344 +0.2707 0.5894149931164451 0.5894154743011867 4.688376785272341e-07 -0.03896412709128935 +0.2708 0.5894423209746893 0.5894427930851766 4.826702428295526e-07 -0.03897701121527823 +0.27090000000000003 0.589469644455383 0.589470107243318 4.964227253156928e-07 -0.03898989381362525 +0.271 0.5894969635577603 0.5894974167762563 5.100928926610182e-07 -0.03900277488600686 +0.2711 0.5895242782810365 0.5895247216846571 5.236785238227348e-07 -0.039015654432099804 +0.2712 0.5895515886244064 0.5895520219692061 5.371774104701021e-07 -0.039028532451580944 +0.2713 0.5895788945870457 0.5895793176306096 5.50587357261989e-07 -0.03904140894412741 +0.27140000000000003 0.5896061961681109 0.5896066086695941 5.639061823048408e-07 -0.03905428390941658 +0.2715 0.5896334933667389 0.5896338950869064 5.77131717416357e-07 -0.03906715734712602 +0.2716 0.5896607861820471 0.5896611768833125 5.902618086806033e-07 -0.03908002925693347 +0.2717 0.5896880746131341 0.5896884540595987 6.032943165312776e-07 -0.03909289963851696 +0.2718 0.5897153586590798 0.5897157266165711 6.162271162513111e-07 -0.03910576849155471 +0.27190000000000003 0.589742638318945 0.589742994555055 6.290580983614458e-07 -0.03911863581572516 +0.272 0.589769913591772 0.5897702578758954 6.41785168731257e-07 -0.03913150161070695 +0.2721 0.5897971844765842 0.5897975165799565 6.544062493007985e-07 -0.03914436587617895 +0.2722 0.5898244509723871 0.5898247706681217 6.669192780806021e-07 -0.03915722861182026 +0.2723 0.5898517130781672 0.5898520201412931 6.793222097900564e-07 -0.03917008981731016 +0.27240000000000003 0.5898789707928935 0.5898792650003922 6.916130159684286e-07 -0.0391829494923282 +0.2725 0.5899062241155169 0.5899065052463587 7.037896853079317e-07 -0.039195807636554086 +0.2726 0.5899334730449703 0.589933740880151 7.158502240978137e-07 -0.03920866424966779 +0.2727 0.5899607175801692 0.5899609719027461 7.277926566406911e-07 -0.039221519331349486 +0.2728 0.5899879577200116 0.5899881983151393 7.396150253635714e-07 -0.039234372881279594 +0.27290000000000003 0.5900151934633774 0.5900154201183434 7.513153909843862e-07 -0.03924722489913868 +0.273 0.5900424248091303 0.59004263731339 7.628918335667034e-07 -0.0392600753846076 +0.2731 0.5900696517561166 0.5900698499013277 7.743424521311493e-07 -0.03927292433736737 +0.2732 0.5900968743031654 0.5900970578832231 7.856653650717416e-07 -0.0392857717570993 +0.2733 0.5901240924490898 0.5901242612601603 7.968587107665126e-07 -0.039298617643484836 +0.27340000000000003 0.5901513061926857 0.5901514600332403 8.079206476330203e-07 -0.03931146199620569 +0.2735 0.5901785155327333 0.5901786542035813 8.188493545724373e-07 -0.039324304814943783 +0.2736 0.5902057204679959 0.5902058437723184 8.296430311083292e-07 -0.03933714609938122 +0.2737 0.5902329209972215 0.5902330287406036 8.402998978862541e-07 -0.03934998584920039 +0.2738 0.5902601171191422 0.590260209109605 8.508181969790751e-07 -0.03936282406408384 +0.27390000000000003 0.590287308832474 0.590287384880507 8.611961918592037e-07 -0.03937566074371432 +0.274 0.5903144961359181 0.5903145560545109 8.714321680924897e-07 -0.03938849588777487 +0.2741 0.5903416790281603 0.5903417226328332 8.815244333659766e-07 -0.0394013294959487 +0.2742 0.5903688575078714 0.5903688846167067 8.914713179042355e-07 -0.03941416156791928 +0.2743 0.5903960315737072 0.5903960420073789 9.012711747469204e-07 -0.03942699210337022 +0.27440000000000003 0.5904232012243091 0.5904231948061135 9.109223798320354e-07 -0.039439821101985406 +0.2745 0.590450366458304 0.590450343014189 9.204233325232902e-07 -0.03945264856344893 +0.2746 0.5904775272743048 0.5904774866328988 9.297724557211229e-07 -0.039465474487445126 +0.2747 0.5905046836709101 0.5905046256635511 9.389681961957663e-07 -0.039478298873658516 +0.2748 0.5905318356467051 0.5905317601074686 9.480090248370487e-07 -0.039491121721773825 +0.27490000000000003 0.5905589832002606 0.5905588899659882 9.568934369597049e-07 -0.039503943031476 +0.275 0.5905861263301352 0.5905860152404608 9.656199525254205e-07 -0.039516762802450256 +0.2751 0.5906132650348734 0.5906131359322516 9.741871162538551e-07 -0.03952958103438195 +0.2752 0.5906403993130075 0.5906402520427392 9.825934981222417e-07 -0.03954239772695673 +0.2753 0.5906675291630565 0.5906673635733153 9.908376934208984e-07 -0.03955521287986039 +0.27540000000000003 0.5906946545835275 0.5906944705253854 9.989183231140508e-07 -0.039568026492779025 +0.2755 0.5907217755729152 0.5907215729003673 1.0068340337288095e-06 -0.03958083856539886 +0.2756 0.5907488921297019 0.5907486706996921 1.01458349829886e-06 -0.0395936490974064 +0.2757 0.5907760042523588 0.590775763924803 1.022165416059151e-06 -0.03960645808848834 +0.2758 0.590803111939345 0.5908028525771557 1.0295785125569168e-06 -0.039619265538331595 +0.27590000000000003 0.5908302151891085 0.590829936658218 1.0368215403733227e-06 -0.03963207144662334 +0.276 0.5908573140000865 0.5908570161694692 1.0438932786516197e-06 -0.03964487581305087 +0.2761 0.5908844083707048 0.5908840911124005 1.0507925340963453e-06 -0.03965767863730181 +0.2762 0.5909114982993792 0.5909111614885139 1.0575181407790346e-06 -0.039670479919063945 +0.2763 0.5909385837845147 0.5909382272993231 1.0640689601382203e-06 -0.03968327965802524 +0.27640000000000003 0.5909656648245065 0.5909652885463521 1.070443881479033e-06 -0.03969607785387395 +0.2765 0.59099274141774 0.5909923452311356 1.0766418221397345e-06 -0.03970887450629852 +0.2766 0.591019813562591 0.591019397355219 1.0826617275472294e-06 -0.039721669614987604 +0.2767 0.5910468812574255 0.5910464449201571 1.0885025715778873e-06 -0.03973446317963006 +0.2768 0.5910739445006012 0.591073487927515 1.0941633564742759e-06 -0.03974725519991503 +0.27690000000000003 0.5911010032904663 0.5911005263788671 1.0996431133447615e-06 -0.03976004567553177 +0.277 0.5911280576253606 0.5911275602757975 1.1049409021635093e-06 -0.039772834606169837 +0.2771 0.5911551075036157 0.5911545896198989 1.110055811825994e-06 -0.039785621991518964 +0.2772 0.5911821529235551 0.591181614412773 1.1149869602600226e-06 -0.03979840783126916 +0.2773 0.5912091938834947 0.5912086346560301 1.1197334952584015e-06 -0.03981119212511058 +0.27740000000000004 0.5912362303817423 0.5912356503512883 1.1242945938683135e-06 -0.03982397487273359 +0.2775 0.5912632624165992 0.5912626615001746 1.128669462557852e-06 -0.03983675607382889 +0.2776 0.5912902899863591 0.5912896681043226 1.1328573380486873e-06 -0.03984953572808725 +0.2777 0.591317313089309 0.591316670165374 1.1368574868164671e-06 -0.03986231383519973 +0.2778 0.5913443317237299 0.5913436676849781 1.1406692050353051e-06 -0.03987509039485763 +0.27790000000000004 0.591371345887896 0.5913706606647903 1.1442918195214702e-06 -0.03988786540675241 +0.278 0.5913983555800761 0.591397649106473 1.1477246873448088e-06 -0.039900638870575794 +0.2781 0.5914253607985331 0.5914246330116952 1.1509671959952783e-06 -0.03991341078601973 +0.2782 0.5914523615415241 0.5914516123821316 1.1540187635494803e-06 -0.0399261811527763 +0.2783 0.591479357807302 0.5914785872194631 1.1568788386151496e-06 -0.0399389499705379 +0.27840000000000004 0.591506349594114 0.5915055575253758 1.1595469005531989e-06 -0.03995171723899708 +0.2785 0.5915333369002036 0.5915325233015615 1.1620224598107853e-06 -0.03996448295784667 +0.2786 0.5915603197238092 0.5915594845497166 1.1643050578102887e-06 -0.03997724712677968 +0.2787 0.5915872980631655 0.5915864412715426 1.1663942668937999e-06 -0.0399900097454893 +0.2788 0.5916142719165036 0.5916133934687453 1.1682896903786322e-06 -0.04000277081366904 +0.27890000000000004 0.5916412412820511 0.5916403411430347 1.1699909631124328e-06 -0.04001553033101256 +0.279 0.5916682061580323 0.5916672842961243 1.1714977510846047e-06 -0.040028288297213666 +0.2791 0.5916951665426688 0.5916942229297318 1.1728097515928404e-06 -0.04004104471196654 +0.2792 0.5917221224341795 0.591721157045578 1.173926693465166e-06 -0.04005379957496544 +0.2793 0.5917490738307807 0.5917480866453866 1.1748483370599416e-06 -0.04006655288590488 +0.27940000000000004 0.5917760207306874 0.5917750117308841 1.1755744739883056e-06 -0.0400793046444797 +0.2795 0.591802963132112 0.5918019323037996 1.1761049278358193e-06 -0.040092054850384806 +0.2796 0.5918299010332662 0.5918288483658647 1.1764395536073557e-06 -0.04010480350331542 +0.2797 0.5918568344323599 0.5918557599188121 1.176578237949144e-06 -0.040117550602966956 +0.2798 0.5918837633276024 0.5918826669643769 1.176520899259792e-06 -0.04013029614903499 +0.27990000000000004 0.5919106877172023 0.5919095695042951 1.1762674879123303e-06 -0.040143040141215405 +0.28 0.591937607599368 0.5919364675403038 1.175817985588079e-06 -0.040155782579204206 +0.2801 0.5919645229723076 0.591963361074141 1.175172406109315e-06 -0.04016852346269773 +0.2802 0.5919914338342297 0.5919902501075451 1.1743307948841597e-06 -0.040181262791392454 +0.2803 0.5920183401833433 0.5920171346422547 1.1732932289620912e-06 -0.040194000564985045 +0.28040000000000004 0.5920452420178584 0.5920440146800081 1.1720598173670105e-06 -0.040206736783172464 +0.2805 0.5920721393359858 0.592070890222544 1.1706307012637751e-06 -0.040219471445651904 +0.2806 0.5920990321359377 0.5920977612715994 1.1690060531810431e-06 -0.04023220455212065 +0.2807 0.5921259204159285 0.592124627828911 1.1671860775108733e-06 -0.04024493610227635 +0.2808 0.5921528041741738 0.5921514898962137 1.1651710104532143e-06 -0.04025766609581675 +0.28090000000000004 0.5921796834088922 0.592178347475242 1.1629611198493706e-06 -0.04027039453243991 +0.281 0.592206558118304 0.5922052005677272 1.1605567052375143e-06 -0.040283121411844 +0.2811 0.5922334283006331 0.5922320491753994 1.1579580980192183e-06 -0.04029584673372753 +0.2812 0.5922602939541061 0.5922588932999859 1.1551656611819006e-06 -0.04030857049778918 +0.2813 0.5922871550769531 0.5922857329432116 1.1521797891322905e-06 -0.040321292703727765 +0.28140000000000004 0.5923140116674079 0.5923125681067984 1.1490009078074515e-06 -0.040334013351242474 +0.2815 0.5923408637237082 0.5923393987924646 1.1456294749523366e-06 -0.04034673244003256 +0.2816 0.5923677112440959 0.5923662250019253 1.1420659792871213e-06 -0.040359449969797595 +0.2817 0.5923945542268176 0.5923930467368919 1.1383109413953818e-06 -0.040372165940237334 +0.2818 0.5924213926701246 0.5924198639990712 1.1343649128359168e-06 -0.0403848803510517 +0.28190000000000004 0.5924482265722736 0.5924466767901665 1.1302284763092807e-06 -0.04039759320194101 +0.282 0.5924750559315257 0.5924734851118756 1.1259022457688062e-06 -0.04041030449260555 +0.2821 0.592501880746149 0.5925002889658916 1.1213868663095816e-06 -0.040423014222745975 +0.2822 0.5925287010144165 0.5925270883539024 1.1166830139464068e-06 -0.04043572239206317 +0.2823 0.592555516734608 0.5925538832775907 1.1117913956693037e-06 -0.04044842900025816 +0.28240000000000004 0.5925823279050098 0.5925806737386328 1.1067127486663608e-06 -0.04046113404703224 +0.2825 0.5926091345239145 0.5926074597386993 1.1014478416004891e-06 -0.0404738375320869 +0.2826 0.5926359365896223 0.5926342412794547 1.0959974730551103e-06 -0.04048653945512387 +0.2827 0.5926627341004405 0.5926610183625567 1.090362472477846e-06 -0.04049923981584507 +0.2828 0.5926895270546838 0.5926877909896556 1.084543699458873e-06 -0.04051193861395263 +0.28290000000000004 0.5927163154506752 0.5927145591623953 1.0785420438419457e-06 -0.04052463584914894 +0.283 0.5927430992867455 0.5927413228824121 1.0723584253358176e-06 -0.04053733152113661 +0.2831 0.5927698785612343 0.5927680821513337 1.0659937937362862e-06 -0.040550025629618375 +0.2832 0.5927966532724895 0.5927948369707814 1.059449128482104e-06 -0.04056271817429733 +0.2833 0.5928234234188685 0.5928215873423669 1.0527254389602891e-06 -0.04057540915487667 +0.28340000000000004 0.5928501889987372 0.5928483332676937 1.0458237637289702e-06 -0.04058809857105985 +0.2835 0.5928769500104715 0.5928750747483569 1.0387451708504525e-06 -0.04060078642255053 +0.2836 0.5929037064524572 0.592901811785942 1.03149075750264e-06 -0.04061347270905263 +0.2837 0.5929304583230898 0.5929285443820258 1.0240616498957689e-06 -0.040626157430270204 +0.2838 0.5929572056207753 0.592955272538175 1.0164590030503629e-06 -0.04063884058590766 +0.28390000000000004 0.5929839483439303 0.5929819962559469 1.0086840007139664e-06 -0.0406515221756695 +0.284 0.5930106864909821 0.593008715536888 1.0007378551113444e-06 -0.04066420219926046 +0.2841 0.593037420060369 0.5930354303825351 9.9262180658366e-07 -0.04067688065638556 +0.2842 0.5930641490505408 0.5930621407944141 9.843371237827636e-07 -0.04068955754674996 +0.2843 0.5930908734599591 0.59308884677404 9.758851031438365e-07 -0.04070223287005908 +0.28440000000000004 0.5931175932870968 0.5931155483229166 9.672670691907026e-07 -0.04071490662601857 +0.2845 0.5931443085304393 0.5931422454425365 9.58484373453361e-07 -0.040727578814334246 +0.2846 0.5931710191884845 0.5931689381343803 9.495383950508529e-07 -0.04074024943471216 +0.2847 0.5931977252597422 0.5931956263999174 9.40430540274928e-07 -0.04075291848685862 +0.2848 0.5932244267427362 0.5932223102406047 9.311622421181998e-07 -0.04076558597048017 +0.28490000000000004 0.5932511236360023 0.5932489896578862 9.217349603019009e-07 -0.040778251885283445 +0.285 0.59327781593809 0.5932756646531938 9.121501809428167e-07 -0.0407909162309754 +0.2851 0.5933045036475629 0.593302335227947 9.024094164422625e-07 -0.04080357900726324 +0.2852 0.5933311867629978 0.593329001383551 8.92514205125261e-07 -0.0408162402138543 +0.2853 0.5933578652829852 0.5933556631213985 8.824661111017651e-07 -0.0408288998504561 +0.28540000000000004 0.5933845392061311 0.5933823204428688 8.722667239058346e-07 -0.040841557916776565 +0.2855 0.5934112085310552 0.5934089733493265 8.619176582735921e-07 -0.040854214412523626 +0.2856 0.5934378732563919 0.5934356218421231 8.514205541432229e-07 -0.04086686933740556 +0.2857 0.5934645333807909 0.5934622659225951 8.407770759888411e-07 -0.04087952269113081 +0.2858 0.5934911889029171 0.5934889055920651 8.299889129037563e-07 -0.040892174473408066 +0.28590000000000004 0.5935178398214505 0.5935155408518407 8.190577779898511e-07 -0.04090482468394621 +0.286 0.5935444861350868 0.5935421717032144 8.079854085241145e-07 -0.04091747332245434 +0.2861 0.5935711278425382 0.5935687981474639 7.96773565348019e-07 -0.04093012038864177 +0.2862 0.5935977649425321 0.5935954201858511 7.85424032673232e-07 -0.04094276588221808 +0.2863 0.5936243974338131 0.5936220378196226 7.739386178318153e-07 -0.040955409802893 +0.28640000000000004 0.5936510253151417 0.5936486510500094 7.623191512207139e-07 -0.040968052150376556 +0.2865 0.593677648585295 0.5936752598782261 7.50567485413578e-07 -0.040980692924378885 +0.2866 0.5937042672430675 0.5937018643054711 7.386854953550515e-07 -0.040993332124610406 +0.2867 0.5937308812872704 0.5937284643329265 7.266750781109721e-07 -0.04100596975078176 +0.2868 0.5937574907167327 0.5937550599617578 7.145381522022376e-07 -0.041018605802603816 +0.28690000000000004 0.5937840955303006 0.5937816511931138 7.022766576880723e-07 -0.041031240279787606 +0.287 0.5938106957268382 0.5938082380281259 6.898925555276492e-07 -0.04104387318204442 +0.2871 0.5938372913052274 0.5938348204679087 6.773878274968226e-07 -0.04105650450908579 +0.2872 0.5938638822643683 0.593861398513559 6.647644757440396e-07 -0.04106913426062338 +0.2873 0.5938904686031792 0.5938879721661565 6.520245224572729e-07 -0.04108176243636916 +0.28740000000000004 0.5939170503205968 0.5939145414267628 6.391700097529984e-07 -0.04109438903603528 +0.2875 0.5939436274155768 0.5939411062964214 6.262029991765949e-07 -0.04110701405933406 +0.2876 0.5939701998870937 0.593967666776158 6.131255713692774e-07 -0.04111963750597815 +0.2877 0.5939967677341406 0.5939942228669799 5.999398257072741e-07 -0.04113225937568034 +0.2878 0.5940233309557301 0.5940207745698755 5.866478803018271e-07 -0.04114487966815361 +0.28790000000000004 0.5940498895508945 0.5940473218858153 5.732518710555023e-07 -0.04115749838311126 +0.288 0.5940764435186848 0.5940738648157508 5.597539517454564e-07 -0.0411701155202667 +0.2881 0.5941029928581724 0.5941004033606136 5.461562938291475e-07 -0.041182731079333595 +0.2882 0.5941295375684483 0.5941269375213174 5.324610855561573e-07 -0.04119534506002587 +0.2883 0.5941560776486234 0.5941534672987557 5.186705321902352e-07 -0.041207957462057604 +0.28840000000000005 0.5941826130978293 0.594179992693803 5.047868551627532e-07 -0.04122056828514313 +0.2885 0.594209143915217 0.5942065137073141 4.908122919894398e-07 -0.041233177528996995 +0.2886 0.5942356700999587 0.5942330303401241 4.7674909595118997e-07 -0.04124578519333394 +0.2887 0.5942621916512473 0.5942595425930479 4.6259953571936574e-07 -0.041258391277868955 +0.2888 0.5942887085682957 0.5942860504668805 4.483658947035396e-07 -0.041270995782317244 +0.28890000000000005 0.5943152208503386 0.594312553962397 4.3405047102373917e-07 -0.04128359870639419 +0.289 0.5943417284966311 0.5943390530803517 4.196555770802357e-07 -0.041296200049815456 +0.2891 0.5943682315064498 0.5943655478214789 4.051835389984326e-07 -0.04130879981229685 +0.2892 0.5943947298790923 0.5943920381864919 3.906366964900876e-07 -0.04132139799355445 +0.2893 0.5944212236138775 0.5944185241760835 3.7601740225656766e-07 -0.041333994593304536 +0.28940000000000005 0.5944477127101465 0.5944450057909259 3.6132802178068246e-07 -0.04134658961126359 +0.2895 0.5944741971672616 0.5944714830316696 3.465709328964728e-07 -0.04135918304714834 +0.2896 0.594500676984607 0.5944979558989447 3.317485254006325e-07 -0.0413717749006757 +0.2897 0.5945271521615887 0.5945244243933603 3.168632006222971e-07 -0.04138436517156287 +0.2898 0.5945536226976346 0.5945508885155035 3.0191737100671023e-07 -0.04139695385952716 +0.28990000000000005 0.5945800885921949 0.5945773482659403 2.8691345999032336e-07 -0.04140954096428616 +0.29 0.594606549844742 0.5946038036452157 2.718539011403731e-07 -0.04142212648555769 +0.2901 0.5946330064547704 0.5946302546538522 2.567411382659035e-07 -0.04143471042305974 +0.2902 0.594659458421797 0.5946567012923514 2.415776246544876e-07 -0.04144729277651057 +0.2903 0.5946859057453615 0.5946831435611926 2.2636582285018303e-07 -0.041459873545628606 +0.29040000000000005 0.594712348425026 0.5947095814608335 2.1110820423719812e-07 -0.04147245273013253 +0.2905 0.5947387864603748 0.5947360149917098 1.958072485958029e-07 -0.04148503032974121 +0.2906 0.5947652198510158 0.5947624441542355 1.8046544363742312e-07 -0.041497606344173786 +0.2907 0.5947916485965792 0.5947888689488017 1.6508528479647344e-07 -0.04151018077314953 +0.2908 0.5948180726967178 0.5948152893757779 1.4966927468218483e-07 -0.04152275361638801 +0.29090000000000005 0.5948444921511081 0.5948417054355115 1.3421992264145421e-07 -0.041535324873608975 +0.291 0.594870906959449 0.594868117128327 1.1873974445353319e-07 -0.04154789454453239 +0.2911 0.5948973171214627 0.5948945244545273 1.032312618651221e-07 -0.04156046262887846 +0.2912 0.5949237226368943 0.594920927414392 8.769700218791421e-08 -0.04157302912636756 +0.2913 0.5949501235055126 0.5949473260081787 7.213949792042595e-08 -0.041585594036720325 +0.29140000000000005 0.5949765197271092 0.5949737202361226 5.656128623451884e-08 -0.041598157359657585 +0.2915 0.595002911301499 0.595000110098436 4.096490868396585e-08 -0.04161071909490041 +0.2916 0.5950292982285207 0.5950264955953088 2.535291072566781e-08 -0.04162327924217009 +0.2917 0.5950556805080358 0.5950528767269079 9.727841336279464e-09 -0.04163583780118808 +0.2918 0.5950820581399296 0.5950792534933779 -5.90774746830891e-09 -0.0416483947716761 +0.29190000000000005 0.5951084311241104 0.5951056258948402 -2.1551300987722455e-08 -0.041660950153356066 +0.292 0.5951347994605104 0.5951319939313943 -3.7200262266445794e-08 -0.041673503945950124 +0.2921 0.5951611631490851 0.5951583576031156 -5.285207252566076e-08 -0.04168605614918064 +0.2922 0.5951875221898135 0.595184716910058 -6.850417157621899e-08 -0.041698606762770186 +0.2923 0.5952138765826981 0.595211071852252 -8.415399823866188e-08 -0.04171115578644155 +0.29240000000000005 0.5952402263277651 0.595237422429705 -9.979899076237309e-08 -0.04172370321991775 +0.2925 0.5952665714250641 0.5952637686424018 -1.1543658724744166e-07 -0.04173624906292198 +0.2926 0.5952929118746683 0.5952901104903047 -1.3106422605893564e-07 -0.04174879331517774 +0.2927 0.5953192476766743 0.5953164479733526 -1.4667934625234302e-07 -0.04176133597640863 +0.2928 0.5953455788312023 0.5953427810914618 -1.6227938800031372e-07 -0.041773877046338545 +0.29290000000000005 0.5953719053383965 0.5953691098445257 -1.7786179300899319e-07 -0.041786416524691596 +0.293 0.595398227198424 0.595395434232415 -1.934240049135394e-07 -0.041798954411192094 +0.2931 0.5954245444114757 0.5954217542549773 -2.089634697569065e-07 -0.041811490705564544 +0.2932 0.5954508569777662 0.5954480699120378 -2.244776363125034e-07 -0.04182402540753371 +0.2933 0.595477164897533 0.5954743812033984 -2.399639566635914e-07 -0.041836558516824524 +0.29340000000000005 0.5955034681710377 0.5955006881288387 -2.554198864357371e-07 -0.0418490900331622 +0.2935 0.5955297667985652 0.5955269906881153 -2.708428853415157e-07 -0.041861619956272106 +0.2936 0.595556060780423 0.5955532888809625 -2.8623041758296663e-07 -0.041874148285879875 +0.29369999999999996 0.5955823501169435 0.5955795827070914 -3.0157995224711076e-07 -0.04188667502171133 +0.2938 0.5956086348084808 0.5956058721661905 -3.1688896368758934e-07 -0.041899200163492495 +0.29390000000000005 0.5956349148554132 0.5956321572579266 -3.321549319965089e-07 -0.041911723710949665 +0.294 0.5956611902581419 0.595658437981943 -3.4737534347628607e-07 -0.041924245663809284 +0.29410000000000003 0.5956874610170917 0.5956847143378606 -3.625476908963865e-07 -0.04193676602179808 +0.29419999999999996 0.5957137271327099 0.5957109863252784 -3.7766947404149764e-07 -0.041949284784642965 +0.2943 0.5957399886054672 0.5957372539437727 -3.9273820007235116e-07 -0.041961801952071026 +0.29440000000000005 0.5957662454358574 0.5957635171928978 -4.0775138396287325e-07 -0.04197431752380967 +0.2945 0.5957924976243969 0.5957897760721852 -4.227065488471293e-07 -0.041986831499586416 +0.29460000000000003 0.5958187451716251 0.5958160305811449 -4.3760122657443556e-07 -0.04199934387912904 +0.29469999999999996 0.5958449880781046 0.5958422807192643 -4.524329579314035e-07 -0.04201185466216558 +0.2948 0.5958712263444198 0.5958685264860092 -4.67199293224807e-07 -0.04202436384842423 +0.29490000000000005 0.5958974599711786 0.5958947678808232 -4.818977925730161e-07 -0.042036871437633405 +0.295 0.5959236889590107 0.5959210049031283 -4.965260263223303e-07 -0.04204937742952178 +0.29510000000000003 0.5959499133085692 0.5959472375523243 -5.11081575491068e-07 -0.042061881823818204 +0.29519999999999996 0.5959761330205283 0.5959734658277898 -5.255620321997778e-07 -0.04207438462025174 +0.2953 0.5960023480955856 0.5959996897288815 -5.399649999765499e-07 -0.04208688581855171 +0.29540000000000005 0.59602855853446 0.5960259092549351 -5.54288094214983e-07 -0.04209938541844761 +0.2955 0.596054764337893 0.5960521244052647 -5.685289425627627e-07 -0.042111883419669184 +0.29560000000000003 0.5960809655066477 0.5960783351791628 -5.826851853935056e-07 -0.042124379821946376 +0.29569999999999996 0.5961071620415095 0.5961045415759012 -5.967544760565602e-07 -0.04213687462500935 +0.2958 0.596133353943285 0.5961307435947308 -6.107344813766069e-07 -0.042149367828588497 +0.29590000000000005 0.5961595412128028 0.5961569412348812 -6.246228819450916e-07 -0.042161859432414406 +0.296 0.5961857238509125 0.5961831344955612 -6.384173726059483e-07 -0.04217434943621787 +0.29610000000000003 0.5962119018584855 0.5962093233759593 -6.521156628025437e-07 -0.042186837839729936 +0.29619999999999996 0.5962380752364143 0.5962355078752434 -6.657154769662554e-07 -0.04219932464268186 +0.2963 0.5962642439856124 0.5962616879925604 -6.792145550438278e-07 -0.0422118098448051 +0.29640000000000005 0.5962904081070142 0.5962878637270381 -6.926106524696163e-07 -0.04222429344583134 +0.2965 0.596316567601575 0.5963140350777828 -7.05901540998255e-07 -0.04223677544549243 +0.29660000000000003 0.596342722470271 0.5963402020438822 -7.19085008787923e-07 -0.042249255843520565 +0.29669999999999996 0.5963688727140986 0.5963663646244032 -7.32158860844434e-07 -0.042261734639648024 +0.2968 0.5963950183340745 0.5963925228183931 -7.451209194375696e-07 -0.042274211833607356 +0.29690000000000005 0.5964211593312357 0.5964186766248805 -7.579690244896575e-07 -0.042286687425131336 +0.297 0.5964472957066397 0.5964448260428736 -7.707010338808828e-07 -0.04229916141395297 +0.29710000000000003 0.5964734274613634 0.596470971071362 -7.833148237823551e-07 -0.0423116337998054 +0.29719999999999996 0.5964995545965037 0.5964971117093161 -7.95808289044686e-07 -0.04232410458242205 +0.2973 0.5965256771131767 0.5965232479556873 -8.081793436420792e-07 -0.04233657376153658 +0.29740000000000005 0.5965517950125185 0.5965493798094083 -8.204259208388631e-07 -0.04234904133688279 +0.2975 0.596577908295684 0.5965755072693933 -8.325459736613361e-07 -0.042361507308194796 +0.29760000000000003 0.596604016963847 0.5966016303345384 -8.445374753418555e-07 -0.042373971675206845 +0.29769999999999996 0.5966301210182008 0.5966277490037214 -8.56398419374349e-07 -0.04238643443765344 +0.2978 0.5966562204599567 0.5966538632758016 -8.681268201804482e-07 -0.042398895595269284 +0.29790000000000005 0.5966823152903451 0.5966799731496211 -8.797207132205109e-07 -0.04241135514778932 +0.298 0.5967084055106142 0.596706078624004 -8.91178155354444e-07 -0.042423813094948686 +0.29810000000000003 0.5967344911220307 0.5967321796977574 -9.024972253135477e-07 -0.04243626943648274 +0.29819999999999997 0.5967605721258793 0.5967582763696708 -9.136760238392938e-07 -0.042448724172127056 +0.2983 0.5967866485234616 0.5967843686385164 -9.247126741551703e-07 -0.04246117730161741 +0.29840000000000005 0.5968127203160979 0.5968104565030501 -9.356053222164817e-07 -0.04247362882468981 +0.2985 0.5968387875051252 0.5968365399620111 -9.463521369046379e-07 -0.04248607874108056 +0.29860000000000003 0.5968648500918978 0.5968626190141221 -9.569513107765548e-07 -0.04249852705052606 +0.29869999999999997 0.5968909080777867 0.5968886936580892 -9.67401059759343e-07 -0.04251097375276293 +0.2988 0.5969169614641794 0.5969147638926029 -9.776996239552194e-07 -0.04252341884752808 +0.29890000000000005 0.5969430102524805 0.596940829716338 -9.878452676970184e-07 -0.042535862334558604 +0.299 0.5969690544441106 0.5969668911279533 -9.978362796592144e-07 -0.042548304213591785 +0.29910000000000003 0.5969950940405063 0.5969929481260925 -1.0076709738293665e-06 -0.042560744484365164 +0.29919999999999997 0.59702112904312 0.5970190007093842 -1.0173476890640298e-06 -0.04257318314661649 +0.2993 0.5970471594534197 0.5970450488764418 -1.0268647897826444e-06 -0.0425856202000837 +0.29940000000000005 0.5970731852728887 0.5970710926258647 -1.0362206661063134e-06 -0.04259805564450499 +0.2995 0.5970992065030256 0.5970971319562371 -1.0454137341631142e-06 -0.042610489479618735 +0.29960000000000003 0.5971252231453438 0.5971231668661293 -1.0544424363656546e-06 -0.04262292170516355 +0.29969999999999997 0.5971512352013714 0.5971491973540975 -1.0633052416608724e-06 -0.04263535232087824 +0.2998 0.5971772426726508 0.5971752234186847 -1.0720006457520803e-06 -0.04264778132650185 +0.29990000000000006 0.5972032455607388 0.5972012450584194 -1.080527171570811e-06 -0.04266020872177363 +0.3 0.597229243867206 0.5972272622718179 -1.0888833692768163e-06 -0.04267263450643306 +0.30010000000000003 0.5972552375936366 0.5972532750573831 -1.0970678166188907e-06 -0.04268505868021987 +0.30019999999999997 0.5972812267416285 0.5972792834136047 -1.1050791191014042e-06 -0.04269748124287388 +0.3003 0.5973072113127926 0.5973052873389605 -1.1129159104839026e-06 -0.042709902194135244 +0.30040000000000006 0.5973331913087528 0.5973312868319155 -1.120576852697841e-06 -0.042722321533744306 +0.3005 0.5973591667311456 0.5973572818909234 -1.1280606362629175e-06 -0.04273473926144161 +0.30060000000000003 0.59738513758162 0.5973832725144259 -1.1353659803703398e-06 -0.04274715537696793 +0.30069999999999997 0.5974111038618374 0.5974092587008526 -1.1424916333546697e-06 -0.042759569880064255 +0.3008 0.5974370655734705 0.5974352404486226 -1.149436372693824e-06 -0.04277198277047178 +0.30090000000000006 0.5974630227182042 0.5974612177561439 -1.1561990052311177e-06 -0.0427843940479319 +0.301 0.5974889752977346 0.5974871906218138 -1.1627783677303771e-06 -0.04279680371218628 +0.30110000000000003 0.5975149233137687 0.5975131590440188 -1.1691733263763382e-06 -0.04280921176297671 +0.30119999999999997 0.5975408667680246 0.5975391230211359 -1.175382777829359e-06 -0.04282161820004535 +0.3013 0.597566805662231 0.5975650825515315 -1.1814056486703084e-06 -0.04283402302313437 +0.30140000000000006 0.5975927399981267 0.5975910376335631 -1.1872408960666991e-06 -0.04284642623198636 +0.3015 0.5976186697774605 0.5976169882655784 -1.1928875077726886e-06 -0.04285882782634396 +0.30160000000000003 0.5976445950019911 0.5976429344459163 -1.1983445022401007e-06 -0.04287122780595015 +0.30169999999999997 0.5976705156734865 0.5976688761729065 -1.2036109288682262e-06 -0.04288362617054803 +0.3018 0.5976964317937241 0.5976948134448707 -1.2086858686144453e-06 -0.042896022919880976 +0.30190000000000006 0.5977223433644899 0.5977207462601224 -1.2135684335223829e-06 -0.042908418053692596 +0.302 0.5977482503875791 0.5977466746169667 -1.2182577667774197e-06 -0.04292081157172665 +0.30210000000000004 0.5977741528647942 0.5977725985137015 -1.2227530435948708e-06 -0.042933203473727144 +0.30219999999999997 0.5978000507979468 0.5977985179486167 -1.2270534706093628e-06 -0.0429455937594383 +0.3023 0.5978259441888556 0.5978244329199963 -1.2311582868185234e-06 -0.04295798242860459 +0.30240000000000006 0.597851833039347 0.5978503434261163 -1.2350667632499146e-06 -0.04297036948097065 +0.3025 0.5978777173512546 0.5978762494652468 -1.2387782025724547e-06 -0.04298275491628136 +0.30260000000000004 0.5979035971264188 0.5979021510356516 -1.2422919403176635e-06 -0.04299513873428178 +0.30269999999999997 0.5979294723666867 0.5979280481355889 -1.2456073443245508e-06 -0.04300752093471724 +0.3028 0.5979553430739113 0.5979539407633103 -1.248723815017172e-06 -0.04301990151733323 +0.30290000000000006 0.5979812092499521 0.5979798289170632 -1.2516407854046285e-06 -0.04303228048187546 +0.303 0.598007070896674 0.5980057125950897 -1.254357721303112e-06 -0.04304465782808997 +0.30310000000000004 0.5980329280159478 0.598031591795627 -1.2568741213914159e-06 -0.04305703355572288 +0.30319999999999997 0.5980587806096483 0.5980574665169076 -1.2591895176550238e-06 -0.043069407664520554 +0.3033 0.5980846286796564 0.5980833367571603 -1.2613034748865104e-06 -0.04308178015422958 +0.30340000000000006 0.5981104722278567 0.59810920251461 -1.2632155910186071e-06 -0.04309415102459681 +0.3035 0.5981363112561386 0.598135063787478 -1.2649254973462476e-06 -0.04310652027536929 +0.30360000000000004 0.5981621457663945 0.5981609205739826 -1.2664328585265672e-06 -0.043118887906294236 +0.30369999999999997 0.5981879757605212 0.5981867728723385 -1.2677373724123697e-06 -0.0431312539171191 +0.3038 0.5982138012404183 0.5982126206807588 -1.2688387704962167e-06 -0.04314361830759156 +0.30390000000000006 0.5982396222079889 0.5982384639974533 -1.2697368176883828e-06 -0.04315598107745952 +0.304 0.5982654386651383 0.5982643028206304 -1.2704313124833888e-06 -0.04316834222647104 +0.30410000000000004 0.5982912506137745 0.5982901371484967 -1.2709220871265359e-06 -0.043180701754374516 +0.30419999999999997 0.5983170580558074 0.5983159669792573 -1.2712090074473714e-06 -0.04319305966091842 +0.3043 0.5983428609931487 0.5983417923111162 -1.2712919728596894e-06 -0.04320541594585156 +0.30440000000000006 0.5983686594277117 0.598367613142277 -1.2711709167501084e-06 -0.043217770608922915 +0.3045 0.5983944533614105 0.5983934294709421 -1.2708458060339822e-06 -0.04323012364988161 +0.30460000000000004 0.5984202427961605 0.5984192412953142 -1.2703166415994893e-06 -0.043242475068477074 +0.30469999999999997 0.5984460277338775 0.5984450486135963 -1.2695834579745657e-06 -0.043254824864458946 +0.3048 0.598471808176477 0.5984708514239914 -1.2686463235489498e-06 -0.04326717303757702 +0.30490000000000006 0.5984975841258755 0.5984966497247033 -1.267505340518671e-06 -0.04327951958758138 +0.305 0.5985233555839882 0.5985224435139376 -1.2661606448860496e-06 -0.04329186451422229 +0.30510000000000004 0.5985491225527299 0.5985482327899 -1.264612406293164e-06 -0.04330420781725019 +0.30519999999999997 0.5985748850340143 0.5985740175507992 -1.2628608285769616e-06 -0.04331654949641583 +0.3053 0.5986006430297539 0.5985997977948447 -1.2609061487145468e-06 -0.043328889551470046 +0.30540000000000006 0.5986263965418595 0.598625573520249 -1.2587486383219826e-06 -0.04334122798216397 +0.3055 0.5986521455722402 0.5986513447252275 -1.2563886016003778e-06 -0.04335356478824905 +0.30560000000000004 0.5986778901228028 0.5986771114079975 -1.253826377167755e-06 -0.04336589996947674 +0.30569999999999997 0.5987036301954514 0.5987028735667803 -1.2510623371153606e-06 -0.04337823352559883 +0.3058 0.5987293657920874 0.5987286311998006 -1.2480968872297105e-06 -0.043390565456367346 +0.30590000000000006 0.5987550969146088 0.5987543843052865 -1.2449304662709437e-06 -0.043402895761534444 +0.306 0.5987808235649105 0.5987801328814706 -1.24156354724958e-06 -0.04341522444085257 +0.30610000000000004 0.5988065457448833 0.5988058769265903 -1.2379966362052741e-06 -0.04342755149407435 +0.30619999999999997 0.5988322634564142 0.5988316164388872 -1.234230272373349e-06 -0.043439876920952615 +0.3063 0.5988579767013855 0.5988573514166076 -1.230265028573374e-06 -0.043452200721240446 +0.30640000000000006 0.5988836854816753 0.5988830818580042 -1.2261015105430317e-06 -0.043464522894691125 +0.3065 0.5989093897991562 0.5989088077613345 -1.221740357326695e-06 -0.04347684344105814 +0.30660000000000004 0.5989350896556959 0.5989345291248623 -1.2171822406092936e-06 -0.04348916236009519 +0.3067 0.5989607850531564 0.5989602459468577 -1.2124278654379594e-06 -0.043501479651556235 +0.3068 0.5989864759933936 0.5989859582255974 -1.2074779693338478e-06 -0.04351379531519538 +0.30690000000000006 0.5990121624782577 0.5990116659593643 -1.2023333226807154e-06 -0.04352610935076696 +0.307 0.5990378445095919 0.5990373691464497 -1.196994728169809e-06 -0.043538421758025615 +0.30710000000000004 0.5990635220892327 0.5990630677851511 -1.1914630212161992e-06 -0.04355073253672607 +0.30720000000000003 0.5990891952190099 0.5990887618737744 -1.185739069570202e-06 -0.04356304168662334 +0.3073 0.5991148639007458 0.5991144514106338 -1.1798237730953343e-06 -0.043575349207472684 +0.3074 0.5991405281362545 0.599140136394051 -1.1737180638793365e-06 -0.04358765509902948 +0.3075 0.5991661879273428 0.599165816822357 -1.1674229056513052e-06 -0.043599959361049385 +0.30760000000000004 0.5991918432758088 0.5991914926938918 -1.160939294253538e-06 -0.043612261993288264 +0.30770000000000003 0.5992174941834423 0.5992171640070043 -1.154268256864377e-06 -0.04362456299550219 +0.3078 0.5992431406520241 0.5992428307600527 -1.1474108523312765e-06 -0.04363686236744746 +0.3079 0.5992687826833262 0.5992684929514056 -1.1403681706989577e-06 -0.0436491601088806 +0.308 0.5992944202791106 0.5992941505794415 -1.1331413332094087e-06 -0.04366145621955832 +0.30810000000000004 0.59932005344113 0.5993198036425488 -1.1257314919410621e-06 -0.04367375069923751 +0.30820000000000003 0.5993456821711274 0.599345452139127 -1.1181398299198175e-06 -0.0436860435476754 +0.3083 0.5993713064708346 0.5993710960675867 -1.1103675608969965e-06 -0.04369833476462929 +0.3084 0.5993969263419738 0.5993967354263492 -1.1024159285999424e-06 -0.043710624349856814 +0.3085 0.5994225417862561 0.5994223702138476 -1.0942862075091764e-06 -0.04372291230311573 +0.30860000000000004 0.5994481528053812 0.5994480004285265 -1.085979701637152e-06 -0.04373519862416404 +0.30870000000000003 0.5994737594010376 0.5994736260688435 -1.077497745194389e-06 -0.04374748331276002 +0.3088 0.5994993615749022 0.5994992471332672 -1.0688417018123175e-06 -0.04375976636866208 +0.3089 0.59952495932864 0.5995248636202795 -1.0600129646265444e-06 -0.043772047791628875 +0.309 0.5995505526639038 0.5995504755283751 -1.0510129557494974e-06 -0.043784327581419286 +0.30910000000000004 0.5995761415823335 0.599576082856062 -1.0418431263814476e-06 -0.043796605737792385 +0.30920000000000003 0.5996017260855571 0.5996016856018614 -1.0325049565607092e-06 -0.04380888226050751 +0.3093 0.5996273061751888 0.599627283764308 -1.0229999546085278e-06 -0.043821157149324136 +0.3094 0.59965288185283 0.5996528773419505 -1.0133296572678585e-06 -0.043833430404002005 +0.3095 0.5996784531200686 0.5996784663333521 -1.0034956291482544e-06 -0.043845702024301075 +0.30960000000000004 0.5997040199784784 0.5997040507370901 -9.93499462559333e-07 -0.04385797200998148 +0.30970000000000003 0.5997295824296196 0.5997296305517565 -9.833427775385317e-07 -0.04387024036080364 +0.3098 0.5997551404750379 0.5997552057759588 -9.730272212404856e-07 -0.043882507076528104 +0.3099 0.599780694116264 0.5997807764083187 -9.6255446785376e-07 -0.04389477215691567 +0.31 0.5998062433548144 0.5998063424474743 -9.519262182122734e-07 -0.043907035601727366 +0.31010000000000004 0.5998317881921906 0.599831903892079 -9.411441996565184e-07 -0.04391929741072442 +0.31020000000000003 0.5998573286298787 0.5998574607408023 -9.302101655894734e-07 -0.04393155758366834 +0.3103 0.5998828646693491 0.5998830129923296 -9.191258953933357e-07 -0.04394381612032076 +0.3104 0.5999083963120566 0.5999085606453627 -9.078931940964541e-07 -0.043956073020443506 +0.3105 0.5999339235594399 0.5999341036986203 -8.965138918737292e-07 -0.0439683282837987 +0.31060000000000004 0.5999594464129216 0.599959642150838 -8.849898440466131e-07 -0.04398058191014867 +0.31070000000000003 0.5999849648739082 0.5999851760007684 -8.7332293063902e-07 -0.043992833899255915 +0.3108 0.6000104789437886 0.6000107052471816 -8.615150560720153e-07 -0.0440050842508832 +0.3109 0.6000359886239355 0.600036229888865 -8.495681487752371e-07 -0.04401733296479343 +0.311 0.6000614939157044 0.6000617499246239 -8.374841611313855e-07 -0.044029580040749805 +0.31110000000000004 0.6000869948204332 0.6000872653532816 -8.252650690043772e-07 -0.04404182547851568 +0.31120000000000003 0.6001124913394421 0.6001127761736799 -8.129128712952571e-07 -0.044054069277854636 +0.3113 0.6001379834740342 0.6001382823846787 -8.004295898034197e-07 -0.04406631143853053 +0.3114 0.6001634712254942 0.6001637839851569 -7.878172688935425e-07 -0.044078551960307355 +0.3115 0.6001889545950887 0.6001892809740119 -7.75077974912719e-07 -0.044090790842949396 +0.31160000000000004 0.6002144335840656 0.6002147733501603 -7.622137962459696e-07 -0.044103028086221026 +0.31170000000000003 0.6002399081936539 0.600240261112538 -7.492268427611304e-07 -0.044115263689886934 +0.3118 0.6002653784250649 0.6002657442601005 -7.361192454757859e-07 -0.044127497653712044 +0.3119 0.6002908442794901 0.6002912227918229 -7.228931561686913e-07 -0.044139729977461434 +0.312 0.6003163057581017 0.6003166967067 -7.095507470189499e-07 -0.04415196066090037 +0.31210000000000004 0.6003417628620532 0.6003421660037468 -6.960942105227463e-07 -0.044164189703794446 +0.31220000000000003 0.6003672155924777 0.6003676306819983 -6.825257587717015e-07 -0.04417641710590933 +0.3123 0.6003926639504893 0.6003930907405106 -6.68847623314095e-07 -0.044188642867011046 +0.3124 0.6004181079371814 0.6004185461783597 -6.550620546830199e-07 -0.044200866986865726 +0.3125 0.6004435475536277 0.6004439969946422 -6.41171322091072e-07 -0.04421308946523971 +0.31260000000000004 0.6004689828008819 0.6004694431884767 -6.271777130140155e-07 -0.044225310301899655 +0.31270000000000003 0.6004944136799767 0.6004948847590019 -6.130835328299611e-07 -0.04423752949661233 +0.3128 0.6005198401919246 0.6005203217053782 -5.988911045556877e-07 -0.0442497470491448 +0.3129 0.6005452623377169 0.6005457540267873 -5.846027682082644e-07 -0.04426196295926425 +0.313 0.6005706801183239 0.6005711817224327 -5.702208807772946e-07 -0.04427417722673816 +0.31310000000000004 0.6005960935346957 0.6005966047915399 -5.557478154755158e-07 -0.04428638985133421 +0.31320000000000003 0.60062150258776 0.6006220232333556 -5.411859615722658e-07 -0.044298600832820244 +0.3133 0.6006469072784237 0.6006474370471491 -5.26537723949394e-07 -0.044310810170964374 +0.3134 0.6006723076075722 0.600672846232212 -5.118055226571716e-07 -0.04432301786553493 +0.3135 0.6006977035760689 0.6006982507878578 -4.969917925812251e-07 -0.04433522391630042 +0.31360000000000005 0.6007230951847553 0.6007236507134228 -4.820989830123246e-07 -0.04434742832302957 +0.31370000000000003 0.6007484824344513 0.6007490460082661 -4.671295572994394e-07 -0.04435963108549134 +0.3138 0.6007738653259546 0.6007744366717691 -4.520859923362597e-07 -0.04437183220345489 +0.3139 0.6007992438600404 0.6007998227033364 -4.369707782142518e-07 -0.044384031676689605 +0.314 0.6008246180374617 0.6008252041023954 -4.2178641779244685e-07 -0.04439622950496505 +0.31410000000000005 0.6008499878589493 0.6008505808683969 -4.065354263366183e-07 -0.04440842568805109 +0.31420000000000003 0.600875353325211 0.6008759530008148 -3.912203310890705e-07 -0.04442062022571768 +0.3143 0.6009007144369322 0.6009013204991465 -3.7584367076903824e-07 -0.04443281311773509 +0.3144 0.6009260711947751 0.6009266833629126 -3.6040799526737555e-07 -0.04444500436387377 +0.3145 0.6009514235993795 0.6009520415916575 -3.449158651330775e-07 -0.044457193963904365 +0.31460000000000005 0.6009767716513617 0.6009773951849493 -3.293698511847021e-07 -0.04446938191759777 +0.31470000000000004 0.6010021153513152 0.6010027441423795 -3.137725341356701e-07 -0.04448156822472506 +0.3148 0.6010274546998101 0.601028088463564 -2.981265040599701e-07 -0.04449375288505754 +0.3149 0.6010527896973934 0.6010534281481424 -2.8243436005909173e-07 -0.04450593589836674 +0.315 0.6010781203445884 0.6010787631957782 -2.6669870976936405e-07 -0.044518117264424374 +0.31510000000000005 0.6011034466418952 0.6011040936061594 -2.509221689664387e-07 -0.0445302969830024 +0.31520000000000004 0.6011287685897905 0.6011294193789976 -2.3510736112120068e-07 -0.04454247505387296 +0.3153 0.6011540861887268 0.6011547405140295 -2.1925691696261795e-07 -0.044554651476808455 +0.3154 0.6011793994391336 0.6011800570110152 -2.0337347402671346e-07 -0.04456682625158144 +0.3155 0.6012047083414161 0.6012053688697401 -1.874596762471703e-07 -0.04457899937796473 +0.31560000000000005 0.601230012895956 0.6012306760900135 -1.7151817346960918e-07 -0.04459117085573134 +0.31570000000000004 0.6012553131031111 0.6012559786716694 -1.555516210664798e-07 -0.044603340684654484 +0.3158 0.601280608963215 0.6012812766145665 -1.3956267945827716e-07 -0.044615508864507644 +0.3159 0.6013059004765777 0.601306569918588 -1.2355401369026908e-07 -0.04462767539506442 +0.316 0.6013311876434849 0.6013318585836415 -1.0752829296759026e-07 -0.04463984027609869 +0.31610000000000005 0.6013564704641985 0.60135714260966 -9.148819023543919e-08 -0.04465200350738458 +0.31620000000000004 0.6013817489389559 0.6013824219966006 -7.543638169855982e-08 -0.04466416508869634 +0.3163 0.6014070230679707 0.6014076967444458 -5.9375546406642554e-08 -0.0446763250198085 +0.3164 0.6014322928514321 0.6014329668532022 -4.3308365789418435e-08 -0.04468848330049577 +0.3165 0.6014575582895052 0.6014582323229019 -2.7237523220376147e-08 -0.04470063993053308 +0.31660000000000005 0.6014828193823312 0.6014834931536014 -1.1165703558144516e-08 -0.04471279490969559 +0.31670000000000004 0.6015080761300264 0.6015087493453823 4.904407297813551e-09 -0.04472494823775866 +0.3168 0.6015333285326836 0.6015340008983515 2.097012286213229e-08 -0.044737099914497876 +0.3169 0.6015585765903708 0.60155924781264 3.702875650199444e-08 -0.04474924993968902 +0.317 0.6015838203031321 0.601584490088404 5.3077621896616134e-08 -0.04476139831310808 +0.31710000000000005 0.6016090596709869 0.6016097277258249 6.911403347895084e-08 -0.04477354503453129 +0.31720000000000004 0.6016342946939306 0.6016349607251086 8.51353069049321e-08 -0.04478569010373505 +0.3173 0.6016595253719346 0.6016601890864864 1.0113875948541962e-07 -0.044797833520496044 +0.3174 0.6016847517049458 0.6016854128102143 1.1712171063896215e-07 -0.04480997528459112 +0.3175 0.6017099736928868 0.6017106318965726 1.3308148234802974e-07 -0.04482211539579732 +0.31760000000000005 0.6017351913356561 0.6017358463458672 1.4901539958922516e-07 -0.044834253853891955 +0.31770000000000004 0.6017604046331283 0.6017610561584286 1.649207908224759e-07 -0.044846390658652514 +0.3178 0.6017856135851531 0.6017862613346118 1.807949884108373e-07 -0.04485852580985668 +0.3179 0.601810818191557 0.6018114618747971 1.9663532905417336e-07 -0.0448706593072824 +0.318 0.6018360184521417 0.6018366577793891 2.1243915428875715e-07 -0.04488279115070781 +0.31810000000000005 0.6018612143666852 0.6018618490488173 2.2820381090360442e-07 -0.044894921339911256 +0.31820000000000004 0.6018864059349416 0.6018870356835356 2.4392665134292946e-07 -0.044907049874671284 +0.3183 0.6019115931566409 0.6019122176840229 2.596050342612566e-07 -0.04491917675476669 +0.3184 0.6019367760314889 0.6019373950507823 2.7523632489118155e-07 -0.04493130197997645 +0.3185 0.6019619545591682 0.6019625677843415 2.9081789545970516e-07 -0.04494342555007976 +0.31860000000000005 0.6019871287393374 0.6019877358852528 3.0634712575028367e-07 -0.04495554746485604 +0.31870000000000004 0.6020122985716309 0.6020128993540922 3.2182140337344567e-07 -0.04496766772408493 +0.31880000000000003 0.6020374640556603 0.602038058191461 3.3723812434272027e-07 -0.04497978632754625 +0.3189 0.6020626251910127 0.6020632123979839 3.52594693539543e-07 -0.04499190327502005 +0.319 0.6020877819772527 0.60208836197431 3.6788852503244485e-07 -0.045004018566286594 +0.31910000000000005 0.6021129344139207 0.6021135069211125 3.8311704252114165e-07 -0.045016132201126394 +0.31920000000000004 0.602138082500534 0.6021386472390888 3.982776799332788e-07 -0.04502824417932011 +0.31930000000000003 0.6021632262365869 0.6021637829289598 4.133678817297426e-07 -0.04504035450064865 +0.3194 0.6021883656215502 0.6021889139914702 4.283851032932384e-07 -0.04505246316489314 +0.3195 0.6022135006548721 0.6022140404273886 4.433268114417688e-07 -0.045064570171834906 +0.3196 0.6022386313359772 0.6022391622375071 4.581904849143559e-07 -0.04507667552125548 +0.31970000000000004 0.602263757664268 0.6022642794226412 4.7297361462084186e-07 -0.04508877921293663 +0.31980000000000003 0.6022888796391237 0.60228939198363 4.876737042386337e-07 -0.04510088124666032 +0.3199 0.6023139972599014 0.6023144999213358 5.022882705735254e-07 -0.045112981622208746 +0.32 0.602339110525935 0.6023396032366437 5.168148439621545e-07 -0.045125080339364285 +0.3201 0.6023642194365368 0.6023647019304623 5.312509686883349e-07 -0.04513717739790953 +0.32020000000000004 0.6023893239909964 0.602389796003723 5.455942034410244e-07 -0.04514927279762734 +0.32030000000000003 0.6024144241885813 0.6024148854573794 5.59842121744536e-07 -0.045161366538300704 +0.3204 0.6024395200285372 0.6024399702924086 5.73992312333238e-07 -0.04517345861971289 +0.3205 0.6024646115100877 0.6024650505098096 5.880423794568657e-07 -0.045185549041647344 +0.3206 0.6024896986324348 0.602490126110604 6.019899436437992e-07 -0.045197637803887775 +0.32070000000000004 0.6025147813947591 0.6025151970958358 6.158326415484083e-07 -0.04520972490621802 +0.32080000000000003 0.6025398597962193 0.6025402634665706 6.295681269641307e-07 -0.04522181034842218 +0.3209 0.6025649338359533 0.6025653252238959 6.431940707540829e-07 -0.045233894130284565 +0.321 0.6025900035130779 0.6025903823689218 6.567081614894388e-07 -0.04524597625158971 +0.3211 0.6026150688266885 0.6026154349027789 6.70108105810252e-07 -0.04525805671212233 +0.32120000000000004 0.6026401297758601 0.60264048282662 6.833916287585229e-07 -0.04527013551166738 +0.32130000000000003 0.6026651863596468 0.6026655261416187 6.965564741667762e-07 -0.045282212650010006 +0.3214 0.6026902385770826 0.6026905648489702 7.096004051854177e-07 -0.04529428812693559 +0.3215 0.6027152864271808 0.6027155989498904 7.225212043382445e-07 -0.04530636194222969 +0.3216 0.6027403299089349 0.6027406284456155 7.353166743551132e-07 -0.045318434095678144 +0.32170000000000004 0.6027653690213183 0.6027656533374031 7.479846383384725e-07 -0.045330504587066944 +0.32180000000000003 0.6027904037632846 0.6027906736265305 7.605229399298974e-07 -0.04534257341618229 +0.3219 0.602815434133768 0.6028156893142957 7.729294438929557e-07 -0.04535464058281061 +0.322 0.6028404601316836 0.6028407004020163 7.852020366405643e-07 -0.045366706086738574 +0.3221 0.6028654817559265 0.6028657068910299 7.973386262905002e-07 -0.04537876992775304 +0.32220000000000004 0.6028904990053736 0.6028907087826938 8.093371431372454e-07 -0.045390832105641044 +0.32230000000000003 0.6029155118788827 0.6029157060783844 8.211955399850535e-07 -0.04540289262018988 +0.3224 0.6029405203752932 0.6029406987794979 8.329117926197949e-07 -0.04541495147118704 +0.3225 0.602965524493426 0.6029656868874488 8.444839000865123e-07 -0.045427008658420254 +0.3226 0.6029905242320838 0.6029906704036707 8.559098850502433e-07 -0.0454390641816774 +0.32270000000000004 0.6030155195900513 0.6030156493296162 8.671877941290873e-07 -0.04545111804074661 +0.32280000000000003 0.6030405105660956 0.6030406236667556 8.783156980607387e-07 -0.04546317023541627 +0.3229 0.6030654971589664 0.6030655934165776 8.892916922298433e-07 -0.04547522076547486 +0.323 0.6030904793673962 0.603090558580589 9.001138971675982e-07 -0.045487269630711216 +0.3231 0.6031154571901002 0.6031155191603139 9.107804583852186e-07 -0.04549931683091427 +0.32320000000000004 0.6031404306257769 0.6031404751572943 9.212895472343607e-07 -0.04551136236587327 +0.32330000000000003 0.603165399673108 0.603165426573089 9.31639360879366e-07 -0.04552340623537753 +0.3234 0.6031903643307591 0.6031903734092742 9.418281226025726e-07 -0.045535448439216725 +0.3235 0.6032153245973795 0.6032153156674426 9.518540824982047e-07 -0.04554748897718067 +0.3236 0.6032402804716028 0.6032402533492034 9.617155171948166e-07 -0.045559527849059395 +0.32370000000000004 0.6032652319520468 0.6032651864561821 9.714107306602049e-07 -0.04557156505464313 +0.32380000000000003 0.6032901790373142 0.6032901149900203 9.809380540903856e-07 -0.04558360059372235 +0.3239 0.6033151217259921 0.6033150389523753 9.902958466867506e-07 -0.04559563446608772 +0.324 0.6033400600166532 0.6033399583449202 9.99482495572801e-07 -0.045607666671530156 +0.3241 0.6033649939078554 0.6033648731693428 1.008496416099458e-06 -0.04561969720984073 +0.32420000000000004 0.603389923398142 0.6033897834273465 1.017336052205886e-06 -0.04563172608081076 +0.32430000000000003 0.6034148484860424 0.6034146891206488 1.0259998765860256e-06 -0.04564375328423175 +0.3244 0.6034397691700724 0.6034395902509824 1.0344863912714608e-06 -0.045655778819895444 +0.3245 0.6034646854487338 0.6034644868200937 1.0427941274926411e-06 -0.045667802687593774 +0.3246 0.6034895973205151 0.6034893788297433 1.0509216463450155e-06 -0.04567982488711891 +0.32470000000000004 0.6035145047838921 0.6035142662817052 1.0588675385669877e-06 -0.04569184541826319 +0.32480000000000003 0.6035394078373274 0.6035391491777673 1.0666304252338055e-06 -0.0457038642808192 +0.3249 0.6035643064792716 0.6035640275197299 1.0742089575077607e-06 -0.045715881474579736 +0.325 0.6035892007081629 0.6035889013094071 1.0816018176651454e-06 -0.04572789699933784 +0.3251 0.6036140905224272 0.6036137705486245 1.0888077184301181e-06 -0.04573991085488666 +0.32520000000000004 0.6036389759204792 0.603638635239221 1.0958254038073711e-06 -0.04575192304101966 +0.32530000000000003 0.6036638569007221 0.6036634953830469 1.102653649109886e-06 -0.04576393355753047 +0.3254 0.6036887334615479 0.6036883509819642 1.1092912611254668e-06 -0.04577594240421293 +0.3255 0.6037136056013379 0.6037132020378466 1.1157370783387854e-06 -0.045787949580861104 +0.3256 0.6037384733184626 0.6037380485525788 1.121989971569759e-06 -0.04579995508726921 +0.32570000000000005 0.6037633366112829 0.6037628905280565 1.1280488432241498e-06 -0.04581195892323181 +0.32580000000000003 0.6037881954781493 0.603787727966186 1.133912628542566e-06 -0.045823961088543586 +0.3259 0.6038130499174029 0.6038125608688832 1.1395802951286171e-06 -0.045835961582999386 +0.326 0.6038378999273754 0.6038373892380751 1.1450508431432027e-06 -0.04584796040639438 +0.3261 0.6038627455063892 0.6038622130756972 1.1503233061094242e-06 -0.045859957558523845 +0.32620000000000005 0.6038875866527582 0.603887032383695 1.1553967501631845e-06 -0.04587195303918335 +0.32630000000000003 0.6039124233647883 0.603911847164023 1.1602702749413663e-06 -0.045883946848168634 +0.3264 0.6039372556407767 0.6039366574186446 1.1649430136373429e-06 -0.04589593898527567 +0.3265 0.6039620834790127 0.6039614631495309 1.1694141328344454e-06 -0.045907929450300616 +0.3266 0.6039869068777786 0.6039862643586624 1.1736828328112736e-06 -0.04591991824303986 +0.32670000000000005 0.6040117258353496 0.6040110610480263 1.1777483480135409e-06 -0.045931905363290025 +0.32680000000000003 0.604036540349993 0.6040358532196174 1.1816099468875407e-06 -0.045943890810847876 +0.3269 0.6040613504199707 0.6040606408754384 1.1852669317691245e-06 -0.045955874585510405 +0.327 0.6040861560435374 0.6040854240174989 1.1887186393000349e-06 -0.04596785668707491 +0.3271 0.6041109572189426 0.604110202647814 1.1919644409275065e-06 -0.04597983711533875 +0.32720000000000005 0.6041357539444296 0.6041349767684061 1.195003742571199e-06 -0.04599181587009964 +0.32730000000000004 0.6041605462182371 0.6041597463813031 1.1978359844011521e-06 -0.04600379295115541 +0.3274 0.6041853340385981 0.6041845114885387 1.2004606417814756e-06 -0.04601576835830415 +0.3275 0.6042101174037409 0.6042092720921519 1.2028772247707487e-06 -0.04602774209134411 +0.3276 0.60423489631189 0.6042340281941867 1.2050852783995758e-06 -0.046039714150073796 +0.32770000000000005 0.6042596707612655 0.6042587797966914 1.2070843828926314e-06 -0.046051684534291926 +0.32780000000000004 0.6042844407500837 0.6042835269017194 1.2088741532245706e-06 -0.04606365324379737 +0.3279 0.6043092062765578 0.6043082695113272 1.2104542404522967e-06 -0.0460756202783893 +0.328 0.6043339673388977 0.6043330076275757 1.2118243298275821e-06 -0.04608758563786703 +0.3281 0.6043587239353108 0.6043577412525292 1.212984142739959e-06 -0.046099549322030135 +0.32820000000000005 0.6043834760640019 0.6043824703882542 1.2139334358285403e-06 -0.04611151133067837 +0.32830000000000004 0.6044082237231736 0.6044071950368208 1.2146720010375311e-06 -0.046123471663611665 +0.3284 0.6044329669110269 0.6044319152003014 1.2151996659492958e-06 -0.046135430320630194 +0.3285 0.6044577056257612 0.60445663088077 1.21551629389538e-06 -0.04614738730153439 +0.3286 0.6044824398655754 0.6044813420803028 1.215621783234866e-06 -0.04615934260612488 +0.32870000000000005 0.6045071696286666 0.6045060488009775 1.2155160686866395e-06 -0.0461712962342024 +0.32880000000000004 0.6045318949132319 0.6045307510448721 1.2151991203857015e-06 -0.046183248185568015 +0.3289 0.6045566157174684 0.604555448814066 1.2146709439941894e-06 -0.04619519846002293 +0.329 0.6045813320395734 0.6045801421106392 1.2139315808679108e-06 -0.046207147057368614 +0.3291 0.6046060438777446 0.6046048309366716 1.2129811081673658e-06 -0.046219093977406714 +0.32920000000000005 0.6046307512301805 0.6046295152942426 1.2118196386357027e-06 -0.046231039219939075 +0.32930000000000004 0.604655454095081 0.6046541951854313 1.2104473209317845e-06 -0.04624298278476781 +0.3294 0.6046801524706473 0.6046788706123157 1.2088643394081444e-06 -0.046254924671695175 +0.3295 0.6047048463550821 0.604703541576973 1.2070709139999636e-06 -0.04626686488052366 +0.3296 0.6047295357465913 0.6047282080814788 1.2050673002250711e-06 -0.04627880341105599 +0.32970000000000005 0.604754220643382 0.6047528701279062 1.2028537891839441e-06 -0.04629074026309507 +0.32980000000000004 0.6047789010436655 0.6047775277183269 1.2004307075041964e-06 -0.046302675436444035 +0.3299 0.6048035769456548 0.6048021808548096 1.1977984176736456e-06 -0.04631460893090619 +0.33 0.6048282483475673 0.6048268295394204 1.1949573174852013e-06 -0.046326540746285116 +0.3301 0.6048529152476243 0.6048514737742221 1.191907839870332e-06 -0.04633847088238456 +0.33020000000000005 0.6048775776440507 0.604876113561274 1.188650453676221e-06 -0.04635039933900853 +0.33030000000000004 0.6049022355350759 0.6049007489026315 1.185185662777588e-06 -0.04636232611596112 +0.3304 0.6049268889189348 0.604925379800346 1.1815140062432228e-06 -0.04637425121304675 +0.3305 0.6049515377938661 0.6049500062564641 1.177636058447007e-06 -0.04638617463007004 +0.3306 0.6049761821581152 0.6049746282730283 1.1735524289568922e-06 -0.04639809636683576 +0.33070000000000005 0.6050008220099325 0.6049992458520752 1.1692637618687662e-06 -0.046410016423148986 +0.33080000000000004 0.6050254573475751 0.6050238589956365 1.1647707365003424e-06 -0.046421934798814915 +0.3309 0.6050500881693057 0.6050484677057375 1.1600740669748255e-06 -0.04643385149363899 +0.331 0.6050747144733943 0.6050730719843981 1.1551745021376458e-06 -0.04644576650742685 +0.3311 0.6050993362581176 0.6050976718336311 1.1500728252511472e-06 -0.046457679839984306 +0.33120000000000005 0.60512395352176 0.6051222672554433 1.1447698539945872e-06 -0.04646959149111751 +0.33130000000000004 0.6051485662626134 0.6051468582518341 1.1392664406029152e-06 -0.046481501460632714 +0.33140000000000003 0.6051731744789777 0.6051714448247951 1.1335634713671716e-06 -0.04649340974833636 +0.3315 0.605197778169161 0.605196026976311 1.1276618664957105e-06 -0.04650531635403521 +0.3316 0.6052223773314801 0.6052206047083579 1.1215625804750218e-06 -0.04651722127753614 +0.33170000000000005 0.6052469719642608 0.605245178022904 1.1152666011260415e-06 -0.046529124518646256 +0.3318 0.6052715620658382 0.6052697469219086 1.1087749501592636e-06 -0.04654102607717291 +0.33190000000000003 0.605296147634557 0.6052943114073221 1.1020886827306509e-06 -0.046552925952923624 +0.332 0.6053207286687714 0.6053188714810858 1.0952088872195898e-06 -0.046564824145706174 +0.3321 0.6053453051668459 0.6053434271451312 1.0881366849513352e-06 -0.046576720655328474 +0.33220000000000005 0.6053698771271558 0.6053679784013801 1.0808732305023216e-06 -0.046588615481598705 +0.3323 0.605394444548087 0.6053925252517443 1.0734197110895405e-06 -0.04660050862432526 +0.33240000000000003 0.6054190074280362 0.6054170676981245 1.065777346376251e-06 -0.04661240008331669 +0.3325 0.605443565765412 0.6054416057424115 1.0579473884164692e-06 -0.046624289858381816 +0.3326 0.6054681195586344 0.6054661393864842 1.0499311216827234e-06 -0.04663617794932964 +0.33270000000000005 0.6054926688061355 0.605490668632211 1.0417298621778759e-06 -0.046648064355969375 +0.3328 0.6055172135063593 0.6055151934814478 1.0333449580457454e-06 -0.04665994907811041 +0.33290000000000003 0.605541753657763 0.605539713936039 1.0247777888217069e-06 -0.04667183211556243 +0.333 0.6055662892588161 0.6055642299978167 1.0160297653216688e-06 -0.04668371346813524 +0.3331 0.6055908203080016 0.6055887416686002 1.0071023294200288e-06 -0.046695593135638896 +0.33320000000000005 0.6056153468038159 0.6056132489501964 9.979969538831401e-07 -0.046707471117883675 +0.3333 0.6056398687447692 0.6056377518443989 9.887151421472673e-07 -0.04671934741468005 +0.33340000000000003 0.6056643861293854 0.6056622503529879 9.792584279855188e-07 -0.04673122202583868 +0.3335 0.6056888989562033 0.60568674447773 9.69628375258047e-07 -0.0467430949511705 +0.3336 0.6057134072237755 0.6057112342203771 9.598265778010262e-07 -0.04675496619048657 +0.33370000000000005 0.60573791093067 0.605735719582668 9.498546588992962e-07 -0.046766835743598176 +0.3338 0.6057624100754697 0.6057602005663264 9.397142712863626e-07 -0.04677870361031688 +0.33390000000000003 0.605786904656773 0.6057846771730613 9.294070967280632e-07 -0.04679056979045439 +0.334 0.6058113946731939 0.6058091494045668 9.189348457727675e-07 -0.04680243428382265 +0.3341 0.6058358801233625 0.6058336172625209 9.082992575570881e-07 -0.04681429709023377 +0.33420000000000005 0.605860361005925 0.6058580807485874 8.975020993895466e-07 -0.04682615820950018 +0.3343 0.6058848373195438 0.605882539864413 8.865451665562851e-07 -0.046838017641434374 +0.33440000000000003 0.6059093090628985 0.6059069946116288 8.754302820157545e-07 -0.04684987538584914 +0.3345 0.6059337762346853 0.6059314449918496 8.641592960656475e-07 -0.04686173144255745 +0.3346 0.6059582388336178 0.6059558910066736 8.527340859543209e-07 -0.046873585811372534 +0.33470000000000005 0.6059826968584272 0.6059803326576818 8.411565557420175e-07 -0.04688543849210774 +0.3348 0.6060071503078622 0.606004769946438 8.294286360788217e-07 -0.04689728948457669 +0.33490000000000003 0.6060315991806898 0.6060292028744896 8.175522834275029e-07 -0.04690913878859323 +0.335 0.6060560434756949 0.6060536314433653 8.055294802022939e-07 -0.04692098640397138 +0.3351 0.6060804831916808 0.6060780556545764 7.933622342970459e-07 -0.04693283233052534 +0.33520000000000005 0.6061049183274698 0.606102475509616 7.810525785856282e-07 -0.04694467656806956 +0.3353 0.606129348881903 0.6061268910099591 7.686025708664168e-07 -0.04695651911641872 +0.33540000000000003 0.6061537748538407 0.6061513021570619 7.560142933071834e-07 -0.04696835997538767 +0.3355 0.6061781962421624 0.606175708952362 7.432898523063169e-07 -0.04698019914479146 +0.3356 0.6062026130457678 0.6062001113972777 7.304313779654681e-07 -0.0469920366244454 +0.33570000000000005 0.6062270252635757 0.6062245094932086 7.174410236177042e-07 -0.047003872414164954 +0.3358 0.6062514328945253 0.6062489032415342 7.043209657719984e-07 -0.0470157065137658 +0.33590000000000003 0.6062758359375764 0.606273292643615 6.910734036691402e-07 -0.04702753892306392 +0.336 0.6063002343917085 0.6062976777007908 6.777005588098906e-07 -0.04703936964187533 +0.3361 0.6063246282559225 0.6063220584143821 6.64204674649671e-07 -0.04705119867001642 +0.33620000000000005 0.6063490175292396 0.6063464347856891 6.505880162099853e-07 -0.04706302600730366 +0.3363 0.606373402210703 0.6063708068159911 6.368528697175968e-07 -0.047074851653553844 +0.33640000000000003 0.606397782299376 0.6063951745065466 6.230015421604396e-07 -0.0470866756085839 +0.3365 0.6064221577943445 0.6064195378585937 6.090363610933291e-07 -0.047098497872210966 +0.3366 0.6064465286947152 0.6064438968733491 5.9495967402734e-07 -0.04711031844425244 +0.33670000000000005 0.6064708949996174 0.6064682515520083 5.807738480689828e-07 -0.04712213732452585 +0.3368 0.606495256708202 0.6064926018957458 5.664812697259158e-07 -0.047133954512849026 +0.33690000000000003 0.6065196138196421 0.6065169479057138 5.52084344157544e-07 -0.04714577000903993 +0.337 0.6065439663331336 0.6065412895830429 5.375854950223635e-07 -0.04715758381291676 +0.3371 0.6065683142478946 0.6065656269288418 5.229871642004058e-07 -0.04716939592429791 +0.33720000000000006 0.6065926575631659 0.6065899599441971 5.082918110715928e-07 -0.047181206343002 +0.3373 0.6066169962782118 0.6066142886301731 4.935019123353257e-07 -0.04719301506884784 +0.33740000000000003 0.6066413303923189 0.6066386129878116 4.786199613165953e-07 -0.0472048221016545 +0.3375 0.6066656599047979 0.6066629330181317 4.6364846789659353e-07 -0.047216627441241193 +0.3376 0.6066899848149822 0.6066872487221298 4.4858995787433464e-07 -0.04722843108742736 +0.33770000000000006 0.6067143051222286 0.6067115601007794 4.33446972619711e-07 -0.04724023304003265 +0.3378 0.6067386208259187 0.6067358671550309 4.1822206854613686e-07 -0.04725203329887698 +0.33790000000000003 0.6067629319254564 0.6067601698858113 4.0291781684687056e-07 -0.047263831863780345 +0.338 0.6067872384202706 0.6067844682940244 3.875368029260251e-07 -0.04727562873456307 +0.3381 0.6068115403098143 0.6068087623805506 3.720816260099902e-07 -0.04728742391104565 +0.33820000000000006 0.6068358375935642 0.6068330521462465 3.5655489873109847e-07 -0.04729921739304874 +0.3383 0.6068601302710217 0.6068573375919447 3.4095924664190314e-07 -0.04731100918039324 +0.33840000000000003 0.6068844183417126 0.6068816187184545 3.2529730779884414e-07 -0.047322799272900284 +0.3385 0.6069087018051874 0.6069058955265612 3.0957173230428126e-07 -0.0473345876703912 +0.3386 0.6069329806610212 0.6069301680170254 2.937851818346493e-07 -0.0473463743726875 +0.33870000000000006 0.6069572549088139 0.6069544361905836 2.7794032934902457e-07 -0.047358159379610916 +0.3388 0.6069815245481904 0.6069787000479487 2.6203985842299105e-07 -0.04736994269098341 +0.33890000000000003 0.6070057895788007 0.6070029595898085 2.460864628600623e-07 -0.0473817243066271 +0.339 0.6070300500003195 0.6070272148168262 2.3008284627534792e-07 -0.04739350422636433 +0.3391 0.6070543058124475 0.6070514657296409 2.14031721665342e-07 -0.047405282450017724 +0.33920000000000006 0.6070785570149098 0.6070757123288664 1.979358109222007e-07 -0.04741705897741 +0.3393 0.6071028036074577 0.6070999546150925 1.8179784424393608e-07 -0.04742883380836416 +0.33940000000000003 0.6071270455898676 0.6071241925888833 1.6562055991237168e-07 -0.047440606942703384 +0.3395 0.6071512829619415 0.607148426250778 1.4940670366864195e-07 -0.047452378380251056 +0.3396 0.6071755157235068 0.6071726556012916 1.3315902823440862e-07 -0.0474641481208308 +0.33970000000000006 0.6071997438744171 0.6071968806409135 1.1688029291634372e-07 -0.047475916164266434 +0.3398 0.6072239674145512 0.6072211013701077 1.0057326313428483e-07 -0.04748768251038194 +0.33990000000000004 0.6072481863438142 0.6072453177893131 8.424070992857358e-08 -0.04749944715900157 +0.34 0.6072724006621367 0.6072695298989439 6.788540943269972e-08 -0.04751121010994975 +0.3401 0.6072966103694756 0.607293737699388 5.151014255064257e-08 -0.047522971363051114 +0.34020000000000006 0.6073208154658132 0.6073179411910089 3.5117694308084424e-08 -0.04753473091813051 +0.3403 0.6073450159511584 0.6073421403741441 1.871085353842561e-08 -0.047546488775013 +0.34040000000000004 0.6073692118255458 0.6073663352491058 2.292412263488197e-09 -0.04755824493352384 +0.3405 0.6073934030890362 0.6073905258161807 -1.4134834658632855e-08 -0.047569999393488493 +0.3406 0.6074175897417163 0.6074147120756302 -3.056809009388539e-08 -0.04758175215473263 +0.34070000000000006 0.6074417717836995 0.6074388940276901 -4.700455507027773e-08 -0.04759350321708217 +0.3408 0.6074659492151246 0.6074630716725702 -6.344142925948128e-08 -0.04760525258036316 +0.34090000000000004 0.607490122036157 0.6074872450104554 -7.987591146493833e-08 -0.04761700024440191 +0.341 0.6075142902469883 0.6075114140415043 -9.630520009240584e-08 -0.04762874620902492 +0.3411 0.6075384538478363 0.6075355787658506 -1.1272649362917275e-07 -0.04764049047405892 +0.34120000000000006 0.6075626128389445 0.6075597391836023 -1.2913699111438692e-07 -0.04765223303933081 +0.3413 0.6075867672205832 0.6075838952948415 -1.4553389263843863e-07 -0.04766397390466772 +0.34140000000000004 0.6076109169930488 0.6076080470996247 -1.6191439981480538e-07 -0.047675713069896986 +0.3415 0.6076350621566634 0.6076321945979832 -1.782757162345494e-07 -0.04768745053484616 +0.3416 0.6076592027117755 0.6076563377899225 -1.9461504796938756e-07 -0.04769918629934294 +0.34170000000000006 0.6076833386587601 0.6076804766754228 -2.1092960405394434e-07 -0.04771092036321531 +0.3418 0.6077074699980181 0.6077046112544383 -2.2721659694024954e-07 -0.04772265272629145 +0.34190000000000004 0.6077315967299759 0.6077287415268984 -2.43473243032033e-07 -0.04773438338839969 +0.342 0.6077557188550867 0.6077528674927063 -2.596967630455471e-07 -0.047746112349368645 +0.3421 0.6077798363738296 0.6077769891517403 -2.75884382623659e-07 -0.04775783960902706 +0.34220000000000006 0.607803949286709 0.6078011065038533 -2.9203333271748955e-07 -0.047769565167203924 +0.3423 0.6078280575942561 0.6078252195488728 -3.081408500929528e-07 -0.047781289023728434 +0.34240000000000004 0.6078521612970273 0.6078493282866009 -3.2420417783729505e-07 -0.04779301117842999 +0.3425 0.6078762603956054 0.6078734327168147 -3.4022056574073423e-07 -0.04780473163113822 +0.3426 0.6079003548905985 0.6078975328392658 -3.5618727090014346e-07 -0.04781645038168289 +0.34270000000000006 0.6079244447826404 0.6079216286536815 -3.721015580382403e-07 -0.04782816742989407 +0.3428 0.6079485300723908 0.607945720159763 -3.8796070013502604e-07 -0.04783988277560195 +0.34290000000000004 0.6079726107605348 0.6079698073571874 -4.037619787955471e-07 -0.04785159641863699 +0.343 0.6079966868477829 0.6079938902456063 -4.195026847148009e-07 -0.0478633083588298 +0.3431 0.6080207583348711 0.6080179688246473 -4.3518011817733626e-07 -0.04787501859601129 +0.34320000000000006 0.6080448252225606 0.6080420430939122 -4.507915895568537e-07 -0.047886727130012414 +0.3433 0.608068887511638 0.6080661130529791 -4.6633441964927247e-07 -0.04789843396066448 +0.34340000000000004 0.6080929452029147 0.6080901787014013 -4.818059403111086e-07 -0.04791013908779894 +0.3435 0.6081169982972274 0.6081142400387074 -4.972034948064197e-07 -0.04792184251124751 +0.3436 0.6081410467954376 0.6081382970644023 -5.125244382786498e-07 -0.04793354423084201 +0.34370000000000006 0.6081650906984317 0.608162349777966 -5.277661381947185e-07 -0.047945244246414546 +0.3438 0.6081891300071206 0.6081863981788548 -5.429259749278881e-07 -0.047956942557797394 +0.34390000000000004 0.60821316472244 0.608210442266501 -5.580013419659302e-07 -0.047968639164823065 +0.344 0.6082371948453499 0.6082344820403127 -5.729896466327711e-07 -0.047980334067324264 +0.3441 0.6082612203768347 0.6082585174996749 -5.878883103938026e-07 -0.04799202726513388 +0.34420000000000006 0.6082852413179032 0.6082825486439483 -6.026947691889495e-07 -0.04800371875808506 +0.3443 0.6083092576695877 0.6083065754724701 -6.174064741681917e-07 -0.048015408546011065 +0.34440000000000004 0.6083332694329452 0.6083305979845551 -6.320208918303427e-07 -0.04802709662874547 +0.3445 0.6083572766090559 0.6083546161794939 -6.465355048418386e-07 -0.04803878300612199 +0.3446 0.6083812791990242 0.6083786300565543 -6.609478118979606e-07 -0.04805046767797458 +0.34470000000000006 0.6084052772039773 0.6084026396149815 -6.752553287914242e-07 -0.04806215064413735 +0.3448 0.6084292706250665 0.6084266448539977 -6.894555884262576e-07 -0.0480738319044447 +0.34490000000000004 0.6084532594634655 0.6084506457728024 -7.035461412341348e-07 -0.048085511458731134 +0.345 0.6084772437203717 0.6084746423705727 -7.175245559654098e-07 -0.048097189306831406 +0.3451 0.6085012233970052 0.6084986346464637 -7.313884198001386e-07 -0.04810886544858052 +0.34520000000000006 0.6085251984946085 0.6085226225996081 -7.451353387921689e-07 -0.04812053988381364 +0.3453 0.6085491690144472 0.6085466062291166 -7.587629384797623e-07 -0.048132212612366145 +0.34540000000000004 0.6085731349578087 0.6085705855340786 -7.722688639133501e-07 -0.048143883634073605 +0.3455 0.6085970963260029 0.6085945605135612 -7.856507806547341e-07 -0.04815555294877183 +0.3456 0.6086210531203613 0.6086185311666108 -7.989063745827973e-07 -0.04816722055629678 +0.34570000000000006 0.6086450053422379 0.6086424974922522 -8.120333525873935e-07 -0.04817888645648469 +0.3458 0.6086689529930073 0.6086664594894893 -8.250294430967031e-07 -0.04819055064917194 +0.34590000000000004 0.6086928960740665 0.6086904171573053 -8.378923961327445e-07 -0.04820221313419517 +0.346 0.6087168345868331 0.6087143704946625 -8.506199840330186e-07 -0.048213873911391154 +0.3461 0.608740768532746 0.6087383195005028 -8.632100017280653e-07 -0.04822553298059695 +0.34620000000000006 0.6087646979132647 0.6087622641737486 -8.756602668524849e-07 -0.04823719034164979 +0.3463 0.6087886227298692 0.6087862045133009 -8.879686206886284e-07 -0.048248845994387064 +0.34640000000000004 0.6088125429840605 0.6088101405180422 -9.00132927972308e-07 -0.04826049993864645 +0.3465 0.608836458677359 0.608834072186835 -9.121510776421982e-07 -0.04827215217426578 +0.3466 0.6088603698113055 0.6088579995185222 -9.240209831173907e-07 -0.0482838027010831 +0.34670000000000006 0.6088842763874602 0.6088819225119281 -9.357405826304621e-07 -0.048295451518936675 +0.3468 0.6089081784074031 0.6089058411658576 -9.47307839532785e-07 -0.04830709862766497 +0.34690000000000004 0.6089320758727329 0.6089297554790969 -9.587207428773947e-07 -0.04831874402710659 +0.347 0.6089559687850683 0.6089536654504143 -9.69977307474501e-07 -0.04833038771710049 +0.3471 0.6089798571460457 0.6089775710785595 -9.810755743910882e-07 -0.04834202969748566 +0.34720000000000006 0.6090037409573209 0.6090014723622645 -9.920136113117373e-07 -0.048353669968101455 +0.3473 0.6090276202205674 0.6090253693002432 -1.0027895129549602e-06 -0.048365308528787315 +0.34740000000000004 0.6090514949374772 0.6090492618911926 -1.0134014011287107e-06 -0.04837694537938297 +0.3475 0.6090753651097596 0.6090731501337919 -1.0238474253687624e-06 -0.04838858051972827 +0.3476 0.6090992307391419 0.6090970340267037 -1.034125763132998e-06 -0.04840021394966332 +0.34770000000000006 0.6091230918273682 0.6091209135685736 -1.0442346200789654e-06 -0.04841184566902841 +0.3478 0.6091469483762005 0.6091447887580312 -1.054172230507966e-06 -0.048423475677664134 +0.34790000000000004 0.6091708003874164 0.6091686595936898 -1.0639368575593444e-06 -0.04843510397541113 +0.348 0.609194647862811 0.6091925260741463 -1.0735267936545778e-06 -0.04844673056211031 +0.3481 0.6092184908041949 0.6092163881979826 -1.0829403604695198e-06 -0.048458355437602824 +0.34820000000000007 0.6092423292133952 0.609240245963765 -1.0921759096838013e-06 -0.04846997860172999 +0.3483 0.609266163092254 0.6092640993700444 -1.1012318232583862e-06 -0.04848160005433333 +0.34840000000000004 0.6092899924426297 0.6092879484153577 -1.1101065131025045e-06 -0.048493219795254616 +0.3485 0.6093138172663952 0.6093117930982263 -1.118798422072853e-06 -0.04850483782433576 +0.3486 0.6093376375654385 0.6093356334171578 -1.1273060237515509e-06 -0.04851645414141894 +0.34870000000000007 0.6093614533416619 0.6093594693706459 -1.1356278233343176e-06 -0.04852806874634649 +0.3488 0.6093852645969822 0.6093833009571703 -1.1437623570198507e-06 -0.04853968163896094 +0.34890000000000004 0.60940907133333 0.6094071281751977 -1.1517081929535156e-06 -0.048551292819105044 +0.349 0.60943287355265 0.6094309510231815 -1.1594639313938782e-06 -0.04856290228662183 +0.3491 0.6094566712568997 0.6094547694995621 -1.1670282047959724e-06 -0.04857451004135442 +0.34920000000000007 0.60948046444805 0.6094785836027677 -1.1743996780055888e-06 -0.048586116083146225 +0.3493 0.6095042531280846 0.6095023933312143 -1.181577048758875e-06 -0.04859772041184077 +0.34940000000000004 0.6095280372989995 0.6095261986833058 -1.1885590476545804e-06 -0.04860932302728184 +0.3495 0.6095518169628033 0.6095499996574347 -1.195344438459367e-06 -0.04862092392931347 +0.3496 0.6095755921215158 0.6095737962519818 -1.2019320185241433e-06 -0.04863252311777979 +0.34970000000000007 0.6095993627771691 0.6095975884653173 -1.208320618756309e-06 -0.048644120592525236 +0.3498 0.6096231289318063 0.6096213762958009 -1.2145091039250655e-06 -0.04865571635339442 +0.34990000000000004 0.609646890587481 0.6096451597417811 -1.2204963728279505e-06 -0.0486673104002321 +0.35 0.6096706477462581 0.6096689388015974 -1.2262813587904375e-06 -0.04867890273288333 +0.3501 0.6096944004102123 0.609692713473579 -1.2318630291385801e-06 -0.048690493351193256 +0.35020000000000007 0.6097181485814287 0.6097164837560455 -1.2372403863647463e-06 -0.04870208225500735 +0.3503 0.6097418922620017 0.6097402496473077 -1.2424124674059733e-06 -0.048713669444171194 +0.35040000000000004 0.6097656314540353 0.6097640111456678 -1.247378344421124e-06 -0.04872525491853065 +0.3505 0.6097893661596426 0.6097877682494194 -1.2521371247353752e-06 -0.04873683867793174 +0.3506 0.6098130963809447 0.6098115209568478 -1.256687950867974e-06 -0.048748420722220645 +0.35070000000000007 0.6098368221200721 0.6098352692662306 -1.2610300011706155e-06 -0.04876000105124383 +0.3508 0.6098605433791627 0.6098590131758378 -1.265162489411109e-06 -0.04877157966484792 +0.35090000000000005 0.6098842601603623 0.6098827526839328 -1.2690846651342014e-06 -0.04878315656287978 +0.351 0.6099079724658242 0.6099064877887717 -1.2727958140501539e-06 -0.048794731745186476 +0.3511 0.6099316802977084 0.6099302184886042 -1.276295257784943e-06 -0.0488063052116152 +0.35120000000000007 0.6099553836581821 0.609953944781674 -1.279582354324349e-06 -0.04881787696201345 +0.3513 0.6099790825494185 0.6099776666662187 -1.2826564979584454e-06 -0.04882944699622885 +0.35140000000000005 0.6100027769735965 0.6100013841404708 -1.2855171193648651e-06 -0.048841015314109275 +0.3515 0.6100264669329016 0.6100250972026575 -1.28816368605289e-06 -0.04885258191550278 +0.3516 0.6100501524295243 0.6100488058510013 -1.2905957018083392e-06 -0.04886414680025766 +0.35170000000000007 0.6100738334656599 0.61007251008372 -1.292812707553992e-06 -0.04887570996822237 +0.3518 0.6100975100435082 0.6100962098990277 -1.294814280683454e-06 -0.048887271419245565 +0.35190000000000005 0.6101211821652741 0.6101199052951344 -1.2966000359493357e-06 -0.048898831153176135 +0.352 0.6101448498331659 0.6101435962702468 -1.298169624908141e-06 -0.04891038916986317 +0.3521 0.6101685130493956 0.6101672828225686 -1.299522736419867e-06 -0.04892194546915593 +0.35220000000000007 0.6101921718161789 0.6101909649503005 -1.3006590963149378e-06 -0.04893350005090393 +0.3523 0.610215826135734 0.6102146426516408 -1.3015784677272713e-06 -0.048945052914956814 +0.35240000000000005 0.610239476010282 0.6102383159247861 -1.3022806510387674e-06 -0.048956604061164505 +0.3525 0.6102631214420462 0.6102619847679313 -1.3027654839903313e-06 -0.048968153489377136 +0.3526 0.6102867624332519 0.6102856491792696 -1.303032841792895e-06 -0.048979701199444975 +0.35270000000000007 0.6103103989861256 0.6103093091569936 -1.3030826369053727e-06 -0.04899124719121855 +0.3528 0.6103340311028959 0.6103329646992945 -1.302914819478751e-06 -0.04900279146454853 +0.35290000000000005 0.6103576587857913 0.6103566158043641 -1.3025293766899537e-06 -0.04901433401928582 +0.353 0.6103812820370413 0.6103802624703937 -1.3019263336300213e-06 -0.049025874855281565 +0.3531 0.6104049008588757 0.6104039046955752 -1.3011057526934877e-06 -0.04903741397238706 +0.35320000000000007 0.6104285152535238 0.6104275424781008 -1.300067733744914e-06 -0.04904895137045384 +0.3533 0.610452125223215 0.6104511758161645 -1.2988124141188884e-06 -0.049060487049333606 +0.35340000000000005 0.6104757307701769 0.610474804707961 -1.297339968620026e-06 -0.049072021008878274 +0.3535 0.610499331896637 0.6104984291516871 -1.2956506095784803e-06 -0.04908355324893998 +0.3536 0.6105229286048202 0.6105220491455421 -1.2937445866278985e-06 -0.049095083769371065 +0.35370000000000007 0.6105465208969503 0.6105456646877271 -1.291622186982977e-06 -0.049106612570024105 +0.3538 0.6105701087752486 0.6105692757764463 -1.2892837350508835e-06 -0.04911813965075175 +0.35390000000000005 0.6105936922419335 0.6105928824099073 -1.2867295926533018e-06 -0.04912966501140697 +0.354 0.6106172712992207 0.6106164845863206 -1.2839601587211202e-06 -0.049141188651842894 +0.3541 0.6106408459493229 0.6106400823039013 -1.280975869599743e-06 -0.049152710571912894 +0.35420000000000007 0.6106644161944486 0.6106636755608682 -1.277777198882557e-06 -0.04916423077147051 +0.3543 0.610687982036803 0.6106872643554448 -1.274364656966842e-06 -0.04917574925036948 +0.35440000000000005 0.6107115434785861 0.6107108486858595 -1.2707387913313273e-06 -0.04918726600846374 +0.3545 0.6107351005219943 0.610734428550346 -1.266900186452924e-06 -0.049198781045607494 +0.3546 0.6107586531692182 0.6107580039471434 -1.2628494636124366e-06 -0.049210294361655055 +0.35470000000000007 0.6107822014224429 0.6107815748744971 -1.2585872808112963e-06 -0.04922180595646098 +0.3548 0.6108057452838485 0.6108051413306582 -1.2541143325495163e-06 -0.04923331582988005 +0.35490000000000005 0.6108292847556087 0.6108287033138848 -1.2494313502420251e-06 -0.049244823981767216 +0.355 0.6108528198398907 0.6108522608224419 -1.2445391014137552e-06 -0.049256330411977634 +0.3551 0.6108763505388555 0.6108758138546018 -1.2394383899216876e-06 -0.04926783512036669 +0.35520000000000007 0.6108998768546561 0.6108993624086441 -1.234130056010363e-06 -0.049279338106789944 +0.3553 0.6109233987894391 0.6109229064828569 -1.2286149757012588e-06 -0.04929083937110317 +0.35540000000000005 0.6109469163453428 0.6109464460755362 -1.2228940610425898e-06 -0.04930233891316233 +0.3555 0.6109704295244976 0.6109699811849867 -1.216968259776241e-06 -0.04931383673282363 +0.3556 0.6109939383290256 0.6109935118095224 -1.210838555310012e-06 -0.04932533282994342 +0.35570000000000007 0.6110174427610398 0.6110170379474662 -1.2045059664955726e-06 -0.04933682720437828 +0.3558 0.6110409428226444 0.6110405595971506 -1.1979715474064179e-06 -0.04934831985598501 +0.35590000000000005 0.6110644385159344 0.6110640767569182 -1.191236387365624e-06 -0.049359810784620574 +0.356 0.6110879298429949 0.6110875894251222 -1.1843016104740034e-06 -0.04937129999014217 +0.3561 0.6111114168059008 0.6111110976001257 -1.177168375721127e-06 -0.04938278747240721 +0.35620000000000007 0.6111348994067167 0.6111346012803035 -1.1698378764857242e-06 -0.04939427323127323 +0.3563 0.6111583776474968 0.6111581004640407 -1.16231134067446e-06 -0.049405757266598016 +0.35640000000000005 0.6111818515302838 0.611181595149735 -1.1545900303611134e-06 -0.049417239578239604 +0.3565 0.6112053210571098 0.6112050853357958 -1.1466752415922876e-06 -0.049428720166056185 +0.35660000000000003 0.6112287862299943 0.6112285710206438 -1.1385683040543437e-06 -0.04944019902990613 +0.3567000000000001 0.6112522470509455 0.6112520522027132 -1.1302705809346225e-06 -0.04945167616964804 +0.3568 0.6112757035219593 0.6112755288804507 -1.1217834689492001e-06 -0.049463151585140724 +0.35690000000000005 0.6112991556450188 0.6112990010523163 -1.1131083978432876e-06 -0.04947462527624318 +0.357 0.6113226034220942 0.6113224687167832 -1.104246829947142e-06 -0.049486097242814636 +0.35710000000000003 0.6113460468551429 0.6113459318723387 -1.095200260481377e-06 -0.049497567484714476 +0.3572000000000001 0.6113694859461082 0.6113693905174835 -1.0859702169185859e-06 -0.04950903600180229 +0.3573 0.6113929206969198 0.6113928446507337 -1.0765582587335398e-06 -0.04952050279393788 +0.35740000000000005 0.6114163511094935 0.6114162942706194 -1.0669659774309448e-06 -0.0495319678609813 +0.3575 0.6114397771857305 0.6114397393756854 -1.0571949959625737e-06 -0.04954343120279272 +0.35760000000000003 0.6114631989275174 0.6114631799644925 -1.0472469687272667e-06 -0.04955489281923256 +0.3577 0.6114866163367256 0.6114866160356165 -1.0371235809603085e-06 -0.04956635271016144 +0.3578 0.6115100294152117 0.6115100475876494 -1.0268265487056727e-06 -0.04957781087544016 +0.35790000000000005 0.6115334381648161 0.6115334746191994 -1.0163576184551992e-06 -0.04958926731492974 +0.358 0.6115568425873636 0.6115568971288904 -1.005718567120839e-06 -0.04960072202849141 +0.35810000000000003 0.6115802426846628 0.6115803151153638 -9.949112011742312e-07 -0.049612175015986526 +0.3582 0.6116036384585065 0.6116037285772778 -9.839373568409915e-07 -0.04962362627727681 +0.3583 0.6116270299106698 0.6116271375133078 -9.72798899517846e-07 -0.04963507581222402 +0.35840000000000005 0.6116504170429112 0.6116505419221465 -9.614977236338529e-07 -0.049646523620690164 +0.3585 0.6116737998569723 0.6116739418025045 -9.500357521508018e-07 -0.049657969702537476 +0.35860000000000003 0.6116971783545768 0.6116973371531107 -9.384149363966809e-07 -0.04966941405762836 +0.3587 0.611720552537431 0.6117207279727123 -9.26637255649343e-07 -0.04968085668582548 +0.3588 0.6117439224072228 0.6117441142600748 -9.147047168311939e-07 -0.04969229758699163 +0.35890000000000005 0.6117672879656219 0.6117674960139831 -9.026193542871486e-07 -0.04970373676098986 +0.359 0.6117906492142793 0.6117908732332404 -8.903832291740077e-07 -0.049715174207683344 +0.35910000000000003 0.6118140061548275 0.61181424591667 -8.77998429404947e-07 -0.04972660992693554 +0.3592 0.61183735878888 0.6118376140631148 -8.654670690666499e-07 -0.049738043918610114 +0.3593 0.6118607071180306 0.6118609776714368 -8.527912881972632e-07 -0.049749476182570807 +0.35940000000000005 0.6118840511438539 0.611884336740519 -8.399732522867964e-07 -0.04976090671868174 +0.3595 0.6119073908679047 0.6119076912692643 -8.27015152138344e-07 -0.04977233552680709 +0.35960000000000003 0.6119307262917173 0.611931041256596 -8.139192034239962e-07 -0.04978376260681126 +0.3597 0.6119540574168061 0.6119543867014587 -8.00687645963194e-07 -0.049795187958558945 +0.3598 0.6119773842446651 0.6119777276028179 -7.873227438892627e-07 -0.049806611581914906 +0.35990000000000005 0.6120007067767675 0.6120010639596603 -7.738267849000113e-07 -0.04981803347674424 +0.36 0.6120240250145658 0.6120243957709937 -7.602020799524212e-07 -0.049829453642912136 +0.36010000000000003 0.6120473389594905 0.6120477230358481 -7.464509630406013e-07 -0.049840872080284 +0.3602 0.6120706486129517 0.6120710457532754 -7.325757903631214e-07 -0.049852288788725496 +0.3603 0.6120939539763375 0.6120943639223497 -7.185789406005672e-07 -0.04986370376810247 +0.36040000000000005 0.6121172550510142 0.6121176775421674 -7.044628137775621e-07 -0.04987511701828096 +0.3605 0.6121405518383264 0.6121409866118469 -6.902298312627675e-07 -0.049886528539127145 +0.36060000000000003 0.6121638443395959 0.6121642911305302 -6.758824354080595e-07 -0.049897938330507485 +0.3607 0.6121871325561228 0.6121875910973814 -6.614230890211736e-07 -0.04990934639228863 +0.3608 0.6122104164891841 0.6122108865115885 -6.468542747828376e-07 -0.04992075272433738 +0.36090000000000005 0.6122336961400343 0.6122341773723623 -6.321784950802378e-07 -0.049932157326520794 +0.361 0.6122569715099049 0.6122574636789377 -6.173982714241522e-07 -0.049943560198706105 +0.36110000000000003 0.6122802426000039 0.6122807454305725 -6.025161441713944e-07 -0.0499549613407607 +0.3612 0.6123035094115168 0.612304022626549 -5.875346718586805e-07 -0.049966360752552265 +0.3613 0.6123267719456049 0.6123272952661731 -5.724564309667057e-07 -0.04997775843394862 +0.36140000000000005 0.6123500302034062 0.6123505633487754 -5.572840153927894e-07 -0.04998915438481777 +0.3615 0.6123732841860343 0.6123738268737103 -5.420200361039296e-07 -0.050000548605027964 +0.36160000000000003 0.6123965338945798 0.6123970858403573 -5.266671204012807e-07 -0.050011941094447634 +0.3617 0.612419779330108 0.6124203402481205 -5.112279118646423e-07 -0.05002333185294541 +0.3618 0.6124430204936613 0.6124435900964285 -4.957050696863252e-07 -0.05003472088039014 +0.36190000000000005 0.6124662573862564 0.6124668353847349 -4.801012681160399e-07 -0.05004610817665083 +0.362 0.612489490008886 0.6124900761125186 -4.6441919626660777e-07 -0.050057493741596695 +0.36210000000000003 0.6125127183625179 0.6125133122792841 -4.4866155739231584e-07 -0.0500688775750972 +0.3622 0.6125359424480953 0.6125365438845608 -4.328310686391168e-07 -0.05008025967702197 +0.3623 0.6125591622665361 0.6125597709279038 -4.169304603923729e-07 -0.05009164004724081 +0.36240000000000006 0.6125823778187331 0.6125829934088941 -4.0096247599930024e-07 -0.05010301868562376 +0.3625 0.6126055891055542 0.612606211327138 -3.8492987108895704e-07 -0.050114395592041054 +0.36260000000000003 0.6126287961278415 0.6126294246822683 -3.6883541328081026e-07 -0.05012577076636308 +0.3627 0.6126519988864121 0.6126526334739435 -3.5268188157411284e-07 -0.05013714420846052 +0.3628 0.6126751973820571 0.612675837701848 -3.36472065938509e-07 -0.050148515918204184 +0.36290000000000006 0.6126983916155421 0.612699037365693 -3.202087667936171e-07 -0.050159885895465085 +0.363 0.6127215815876069 0.6127222324652155 -3.0389479462739066e-07 -0.05017125414011443 +0.36310000000000003 0.6127447672989653 0.6127454230001792 -2.875329693508011e-07 -0.05018262065202367 +0.3632 0.6127679487503055 0.6127686089703746 -2.711261199439541e-07 -0.05019398543106442 +0.3633 0.6127911259422891 0.6127917903756179 -2.546770838801615e-07 -0.050205348477108495 +0.36340000000000006 0.6128142988755522 0.6128149672157532 -2.3818870671654668e-07 -0.05021670979002794 +0.3635 0.6128374675507039 0.6128381394906502 -2.216638415319938e-07 -0.05022806936969494 +0.36360000000000003 0.6128606319683274 0.6128613072002065 -2.0510534844142558e-07 -0.050239427215981916 +0.3637 0.61288379212898 0.6128844703443457 -1.8851609417253057e-07 -0.050250783328761484 +0.3638 0.6129069480331921 0.6129076289230189 -1.7189895148983503e-07 -0.050262137707906496 +0.36390000000000006 0.6129300996814673 0.6129307829362041 -1.5525679872632758e-07 -0.05027349035328992 +0.364 0.6129532470742833 0.6129539323839064 -1.3859251926304217e-07 -0.05028484126478499 +0.36410000000000003 0.6129763902120908 0.6129770772661579 -1.2190900109537717e-07 -0.05029619044226511 +0.3642 0.6129995290953143 0.6130002175830183 -1.0520913625369777e-07 -0.050307537885603916 +0.3643 0.613022663724351 0.6130233533345739 -8.849582035057313e-08 -0.050318883594675214 +0.36440000000000006 0.6130457940995717 0.6130464845209388 -7.177195205862463e-08 -0.05033022756935297 +0.3645 0.6130689202213206 0.613069611142254 -5.5040432605721334e-08 -0.050341569809511426 +0.36460000000000004 0.6130920420899151 0.6130927331986882 -3.8304165293160525e-08 -0.05035291031502497 +0.3647 0.6131151597056455 0.613115850690437 -2.156605496636023e-08 -0.050364249085768226 +0.3648 0.6131382730687756 0.6131389636177236 -4.829007528052431e-09 -0.05037558612161596 +0.36490000000000006 0.6131613821795423 0.6131620719807986 1.190407058256765e-08 -0.050386921422443234 +0.365 0.6131844870381556 0.6131851757799399 2.863027288337039e-08 -0.05039825498812518 +0.36510000000000004 0.6132075876447991 0.6132082750154527 4.534669336038466e-08 -0.05040958681853722 +0.3652 0.6132306839996287 0.6132313696876697 6.205042697021712e-08 -0.050420916913554964 +0.3653 0.6132537761027743 0.6132544597969509 7.873857013965258e-08 -0.05043224527305419 +0.36540000000000006 0.6132768639543386 0.6132775453436838 9.540822130255089e-08 -0.0504435718969109 +0.3655 0.6132999475543974 0.613300626328283 1.1205648136475288e-07 -0.050454896785001285 +0.36560000000000004 0.6133230269030003 0.6133237027511906 1.2868045422970154e-07 -0.05046621993720173 +0.3657 0.6133461020001696 0.6133467746128757 1.4527724729457292e-07 -0.05047754135338881 +0.3658 0.6133691728459008 0.6133698419138351 1.6184397198804046e-07 -0.05048886103343932 +0.36590000000000006 0.6133922394401631 0.6133929046545926 1.7837774417966967e-07 -0.05050017897723024 +0.366 0.6134153017828992 0.6134159628356992 1.948756848321742e-07 -0.050511495184638766 +0.36610000000000004 0.6134383598740244 0.6134390164577331 2.1133492038305501e-07 -0.05052280965554227 +0.3662 0.6134614137134283 0.6134620655212992 2.2775258326501735e-07 -0.050534122389818296 +0.3663 0.6134844633009736 0.6134851100270302 2.441258124957768e-07 -0.05054543338734466 +0.36640000000000006 0.6135075086364965 0.613508149975585 2.6045175406663734e-07 -0.05055674264799928 +0.3665 0.6135305497198071 0.6135311853676501 2.7672756144209165e-07 -0.050568050171660384 +0.36660000000000004 0.6135535865506891 0.6135542162039384 2.9295039617044383e-07 -0.05057935595820634 +0.3667 0.6135766191288998 0.6135772424851895 3.091174283209597e-07 -0.05059066000751569 +0.3668 0.6135996474541704 0.6136002642121703 3.2522583691407814e-07 -0.0506019623194672 +0.36690000000000006 0.6136226715262061 0.6136232813856737 3.4127281051121727e-07 -0.05061326289393983 +0.367 0.6136456913446859 0.6136462940065194 3.5725554768661905e-07 -0.050624561730812735 +0.36710000000000004 0.6136687069092633 0.6136693020755535 3.7317125746449964e-07 -0.05063585882996529 +0.3672 0.6136917182195658 0.6136923055936485 3.890171598602832e-07 -0.050647154191277015 +0.3673 0.6137147252751949 0.613715304561703 4.0479048631081316e-07 -0.05065844781462769 +0.36740000000000006 0.6137377280757267 0.613738298980642 4.204884802849751e-07 -0.05066973969989724 +0.3675 0.6137607266207121 0.6137612888514163 4.3610839763064124e-07 -0.05068102984696585 +0.36760000000000004 0.6137837209096764 0.6137842741750027 4.516475071297821e-07 -0.050692318255713825 +0.3677 0.6138067109421195 0.6138072549524036 4.671030909564333e-07 -0.05070360492602171 +0.3678 0.6138296967175162 0.6138302311846475 4.824724451069073e-07 -0.05071488985777024 +0.36790000000000006 0.6138526782353166 0.6138532028727881 4.977528800381714e-07 -0.050726173050840366 +0.368 0.6138756554949454 0.6138761700179047 5.129417209592813e-07 -0.05073745450511319 +0.36810000000000004 0.6138986284958029 0.6138991326211019 5.280363084281259e-07 -0.05074873422047008 +0.3682 0.6139215972372647 0.6139220906835091 5.430339987400057e-07 -0.05076001219679253 +0.3683 0.6139445617186823 0.6139450442062813 5.579321643578439e-07 -0.05077128843396226 +0.36840000000000006 0.6139675219393821 0.6139679931905978 5.727281945228091e-07 -0.05078256293186122 +0.3685 0.6139904778986671 0.6139909376376628 5.874194955596268e-07 -0.050793835690371526 +0.36860000000000004 0.6140134295958162 0.6140138775487051 6.020034914733241e-07 -0.05080510670937547 +0.3687 0.6140363770300838 0.6140368129249779 6.164776243655634e-07 -0.0508163759887556 +0.3688 0.6140593202007015 0.6140597437677584 6.30839354726076e-07 -0.05082764352839458 +0.36890000000000006 0.6140822591068769 0.6140826700783478 6.450861620710402e-07 -0.050838909328175336 +0.369 0.6141051937477944 0.6141055918580715 6.592155454010484e-07 -0.05085017338798094 +0.36910000000000004 0.6141281241226151 0.6141285091082782 6.732250235619297e-07 -0.050861435707694726 +0.36920000000000003 0.6141510502304773 0.6141514218303403 6.871121355500609e-07 -0.050872696287200175 +0.3693 0.6141739720704968 0.6141743300256538 7.008744412062562e-07 -0.05088395512638098 +0.36940000000000006 0.6141968896417662 0.614197233695637 7.145095216321007e-07 -0.050895212225121 +0.3695 0.6142198029433563 0.614220132841732 7.280149792454615e-07 -0.050906467583304374 +0.36960000000000004 0.6142427119743152 0.6142430274654032 7.413884388074443e-07 -0.05091772120081533 +0.36970000000000003 0.6142656167336694 0.6142659175681375 7.546275472558595e-07 -0.05092897307753838 +0.3698 0.6142885172204232 0.6142888031514442 7.677299745656452e-07 -0.050940223213358164 +0.3699 0.6143114134335601 0.6143116842168547 7.806934138043786e-07 -0.050951471608159576 +0.37 0.6143343053720416 0.6143345607659221 7.935155819649431e-07 -0.05096271826182767 +0.37010000000000004 0.6143571930348082 0.6143574328002216 8.061942198822614e-07 -0.05097396317424771 +0.37020000000000003 0.6143800764207795 0.6143803003213493 8.187270930659629e-07 -0.05098520634530516 +0.3703 0.6144029555288545 0.6144031633309229 8.311119918669174e-07 -0.050996447774885684 +0.3704 0.6144258303579119 0.6144260218305813 8.433467318103016e-07 -0.051007687462875144 +0.3705 0.6144487009068098 0.614448875821983 8.55429154206222e-07 -0.051018925409159546 +0.37060000000000004 0.6144715671743866 0.6144717253068085 8.673571264550262e-07 -0.05103016161362516 +0.37070000000000003 0.6144944291594606 0.6144945702867576 8.791285421860806e-07 -0.0510413960761584 +0.3708 0.6145172868608314 0.6145174107635505 8.907413221737048e-07 -0.05105262879664595 +0.3709 0.6145401402772785 0.6145402467389269 9.021934141151267e-07 -0.05106385977497459 +0.371 0.6145629894075629 0.6145630782146465 9.134827932133494e-07 -0.051075089011031395 +0.37110000000000004 0.6145858342504267 0.6145859051924876 9.246074628432854e-07 -0.05108631650470352 +0.37120000000000003 0.6146086748045934 0.614608727674248 9.355654546072678e-07 -0.05109754225587845 +0.3713 0.6146315110687686 0.6146315456617443 9.46354828390561e-07 -0.051108766264443765 +0.3714 0.6146543430416399 0.614654359156811 9.569736734438283e-07 -0.05111998853028728 +0.3715 0.6146771707218772 0.6146771681613015 9.67420108216599e-07 -0.051131209053297 +0.37160000000000004 0.6146999941081325 0.6146999726770868 9.776922808291122e-07 -0.05114242783336113 +0.37170000000000003 0.6147228131990414 0.6147227727060554 9.877883692388512e-07 -0.05115364487036807 +0.3718 0.6147456279932224 0.6147455682501134 9.977065819899433e-07 -0.051164860164206405 +0.3719 0.6147684384892772 0.6147683593111841 1.0074451579633603e-06 -0.05117607371476496 +0.372 0.6147912446857915 0.6147911458912072 1.0170023671818296e-06 -0.051187285521932635 +0.37210000000000004 0.6148140465813351 0.6148139279921395 1.0263765110596346e-06 -0.051198495585598705 +0.37220000000000003 0.6148368441744614 0.6148367056159536 1.0355659222360813e-06 -0.05120970390565247 +0.3723 0.6148596374637093 0.6148594787646381 1.0445689655469437e-06 -0.05122091048198355 +0.3724 0.6148824264476019 0.614882247440197 1.0533840377191517e-06 -0.05123211531448166 +0.3725 0.6149052111246481 0.6149050116446505 1.0620095682589703e-06 -0.05124331840303679 +0.37260000000000004 0.6149279914933418 0.614927771380033 1.0704440192299547e-06 -0.05125451974753911 +0.37270000000000003 0.6149507675521627 0.6149505266483939 1.0786858856137727e-06 -0.051265719347878935 +0.3728 0.614973539299577 0.6149732774517969 1.0867336960873608e-06 -0.05127691720394684 +0.3729 0.6149963067340368 0.6149960237923202 1.0945860124400575e-06 -0.05128811331563354 +0.373 0.6150190698539814 0.6150187656720554 1.1022414305172923e-06 -0.05129930768283 +0.37310000000000004 0.6150418286578367 0.615041503093108 1.1096985802760972e-06 -0.05131050030542733 +0.37320000000000003 0.6150645831440165 0.6150642360575961 1.1169561261181737e-06 -0.05132169118331689 +0.3733 0.6150873333109217 0.615086964567651 1.1240127666400923e-06 -0.051332880316390155 +0.3734 0.6151100791569415 0.6151096886254165 1.13086723571576e-06 -0.05134406770453884 +0.3735 0.6151328206804534 0.6151324082330485 1.1375183019413093e-06 -0.05135525334765489 +0.37360000000000004 0.6151555578798233 0.615155123392715 1.1439647693567423e-06 -0.051366437245630364 +0.37370000000000003 0.6151782907534069 0.6151778341065955 1.150205477334909e-06 -0.0513776193983576 +0.3738 0.6152010192995482 0.6152005403768805 1.1562393011921301e-06 -0.05138879980572913 +0.3739 0.6152237435165814 0.6152232422057714 1.1620651521326852e-06 -0.05139997846763755 +0.374 0.6152464634028305 0.6152459395954804 1.167681977276569e-06 -0.05141115538397581 +0.37410000000000004 0.6152691789566098 0.6152686325482295 1.1730887601590911e-06 -0.051422330554636964 +0.37420000000000003 0.6152918901762245 0.615291321066251 1.1782845209251658e-06 -0.05143350397951429 +0.3743 0.6153145970599704 0.6153140051517865 1.183268316468089e-06 -0.05144467565850123 +0.3744 0.6153372996061353 0.6153366848070869 1.1880392402352502e-06 -0.05145584559149152 +0.3745 0.6153599978129976 0.6153593600344116 1.19259642311631e-06 -0.05146701377837895 +0.37460000000000004 0.6153826916788288 0.6153820308360292 1.1969390329436003e-06 -0.05147818021905757 +0.37470000000000003 0.6154053812018923 0.6154046972142155 1.2010662747974354e-06 -0.05148934491342168 +0.3748 0.6154280663804439 0.6154273591712547 1.2049773916722462e-06 -0.0515005078613656 +0.3749 0.6154507472127335 0.6154500167094388 1.2086716638937123e-06 -0.05151166906278411 +0.375 0.6154734236970034 0.6154726698310657 1.2121484096183632e-06 -0.05152282851757194 +0.37510000000000004 0.6154960958314899 0.6154953185384416 1.2154069851388893e-06 -0.051533986225624155 +0.37520000000000003 0.6155187636144238 0.6155179628338777 1.218446784412297e-06 -0.05154514218683592 +0.3753 0.6155414270440305 0.615540602719692 1.2212672401146207e-06 -0.051556296401102736 +0.3754 0.6155640861185293 0.6155632381982078 1.2238678226694777e-06 -0.051567448868320126 +0.3755 0.6155867408361357 0.615585869271754 1.2262480410529797e-06 -0.0515785995883839 +0.37560000000000004 0.6156093911950604 0.6156084959426643 1.2284074427659775e-06 -0.051589748561190064 +0.37570000000000003 0.61563203719351 0.6156311182132771 1.2303456140561053e-06 -0.05160089578663481 +0.3758 0.6156546788296875 0.6156537360859348 1.2320621794459363e-06 -0.05161204126461451 +0.3759 0.6156773161017923 0.615676349562984 1.2335568024823829e-06 -0.05162318499502573 +0.376 0.6156999490080213 0.6156989586467747 1.2348291854591409e-06 -0.05163432697776528 +0.37610000000000005 0.6157225775465679 0.6157215633396597 1.2358790695277122e-06 -0.051645467212730035 +0.37620000000000003 0.615745201715624 0.6157441636439951 1.2367062346974045e-06 -0.051656605699817205 +0.3763 0.6157678215133797 0.6157667595621392 1.2373104999741091e-06 -0.051667742438924136 +0.3764 0.6157904369380228 0.6157893510964523 1.237691723582346e-06 -0.051678877429948346 +0.3765 0.6158130479877406 0.6158119382492963 1.2378498024934181e-06 -0.051690010672787584 +0.37660000000000005 0.6158356546607195 0.6158345210230347 1.2377846728972575e-06 -0.05170114216733978 +0.37670000000000003 0.6158582569551455 0.6158570994200321 1.2374963100914016e-06 -0.0517122719135031 +0.3768 0.6158808548692037 0.6158796734426528 1.2369847287307945e-06 -0.05172339991117578 +0.3769 0.6159034484010806 0.6159022430932624 1.23624998205063e-06 -0.05173452616025634 +0.377 0.6159260375489628 0.6159248083742255 1.2352921630598424e-06 -0.05174565066064351 +0.37710000000000005 0.6159486223110382 0.6159473692879069 1.2341114035696599e-06 -0.051756773412236196 +0.37720000000000004 0.615971202685496 0.6159699258366702 1.2327078745544284e-06 -0.05176789441493349 +0.3773 0.6159937786705268 0.6159924780228774 1.2310817860960999e-06 -0.051779013668634626 +0.3774 0.6160163502643239 0.6160150258488895 1.2292333872732097e-06 -0.0517901311732391 +0.3775 0.6160389174650824 0.6160375693170648 1.2271629664106776e-06 -0.05180124692864653 +0.37760000000000005 0.6160614802710014 0.6160601084297602 1.2248708507467398e-06 -0.05181236093475684 +0.37770000000000004 0.6160840386802819 0.6160826431893294 1.2223574064884613e-06 -0.0518234731914701 +0.3778 0.6161065926911296 0.6161051735981229 1.2196230386452012e-06 -0.05183458369868652 +0.3779 0.6161291423017534 0.6161276996584878 1.216668191139636e-06 -0.051845692456306575 +0.378 0.6161516875103669 0.6161502213727675 1.2134933468632703e-06 -0.05185679946423086 +0.37810000000000005 0.6161742283151879 0.6161727387433014 1.2100990271213252e-06 -0.05186790472236017 +0.37820000000000004 0.61619676471444 0.616195251772424 1.2064857920213168e-06 -0.05187900823059556 +0.3783 0.6162192967063518 0.616217760462465 1.2026542404175444e-06 -0.05189010998883825 +0.3784 0.6162418242891574 0.616240264815749 1.1986050093282241e-06 -0.051901209996989606 +0.3785 0.6162643474610978 0.6162627648345949 1.1943387741575329e-06 -0.05191230825495127 +0.37860000000000005 0.6162868662204196 0.6162852605213156 1.1898562485290753e-06 -0.05192340476262498 +0.37870000000000004 0.6163093805653768 0.6163077518782177 1.1851581842858838e-06 -0.05193449951991275 +0.3788 0.6163318904942305 0.6163302389076011 1.180245371434907e-06 -0.05194559252671676 +0.3789 0.6163543960052494 0.6163527216117586 1.1751186377306766e-06 -0.051956683782939356 +0.379 0.6163768970967102 0.6163751999929756 1.1697788484255067e-06 -0.05196777328848309 +0.37910000000000005 0.6163993937668975 0.61639767405353 1.1642269066580724e-06 -0.05197886104325075 +0.37920000000000004 0.616421886014105 0.6164201437956909 1.1584637531203423e-06 -0.05198994704714524 +0.3793 0.6164443738366348 0.6164426092217195 1.1524903656967567e-06 -0.052001031300069646 +0.3794 0.6164668572327989 0.6164650703338681 1.1463077592699378e-06 -0.052012113801927384 +0.3795 0.616489336200919 0.6164875271343799 1.139916985998246e-06 -0.05202319455262194 +0.37960000000000005 0.6165118107393261 0.6165099796254887 1.1333191345108684e-06 -0.05203427355205706 +0.37970000000000004 0.6165342808463627 0.6165324278094177 1.126515330296396e-06 -0.05204535080013659 +0.3798 0.6165567465203807 0.6165548716883806 1.1195067353697574e-06 -0.05205642629676464 +0.3799 0.6165792077597442 0.6165773112645803 1.1122945477171076e-06 -0.05206750004184551 +0.38 0.6166016645628282 0.6165997465402088 1.1048800014623605e-06 -0.052078572035283655 +0.38010000000000005 0.6166241169280194 0.616622177517447 1.0972643667006565e-06 -0.05208964227698379 +0.38020000000000004 0.6166465648537169 0.616644604198464 1.089448949082028e-06 -0.05210071076685074 +0.3803 0.6166690083383317 0.6166670265854173 1.0814350897558889e-06 -0.05211177750478957 +0.3804 0.6166914473802879 0.6166894446804518 1.0732241647604113e-06 -0.05212284249070551 +0.3805 0.6167138819780227 0.6167118584857004 1.0648175854111042e-06 -0.05213390572450401 +0.38060000000000005 0.6167363121299864 0.6167342680032825 1.0562167974959014e-06 -0.052144967206090714 +0.38070000000000004 0.6167587378346435 0.6167566732353047 1.047423281441695e-06 -0.05215602693537144 +0.3808 0.6167811590904723 0.6167790741838598 1.0384385518702466e-06 -0.05216708491225221 +0.3809 0.6168035758959652 0.6168014708510263 1.0292641573761419e-06 -0.052178141136639156 +0.381 0.61682598824963 0.6168238632388696 1.01990168022148e-06 -0.05218919560843876 +0.38110000000000005 0.6168483961499887 0.61684625134944 1.0103527361138287e-06 -0.05220024832755757 +0.38120000000000004 0.6168707995955792 0.6168686351847729 1.0006189738731575e-06 -0.052211299293902384 +0.38130000000000003 0.6168931985849551 0.6168910147468883 9.907020751820372e-07 -0.05222234850738015 +0.3814 0.6169155931166852 0.6169133900377917 9.806037543913515e-07 -0.05223339596789807 +0.3815 0.6169379831893554 0.6169357610594715 9.703257583260072e-07 -0.05224444167536341 +0.38160000000000005 0.6169603688015679 0.6169581278139014 9.59869865424512e-07 -0.05225548562968381 +0.38170000000000004 0.6169827499519414 0.6169804903030377 9.492378860442852e-07 -0.05226652783076691 +0.38180000000000003 0.6170051266391123 0.6170028485288209 9.384316618787913e-07 -0.05227756827852073 +0.3819 0.6170274988617344 0.6170252024931739 9.274530659020286e-07 -0.05228860697285334 +0.382 0.6170498666184786 0.6170475521980027 9.163040014525947e-07 -0.05229964391367306 +0.3821 0.6170722299080348 0.6170698976451954 9.04986402650021e-07 -0.05231067910088838 +0.38220000000000004 0.6170945887291105 0.6170922388366226 8.93502233534349e-07 -0.05232171253440801 +0.38230000000000003 0.617116943080432 0.6171145757741366 8.818534880938866e-07 -0.052332744214140775 +0.3824 0.6171392929607448 0.6171369084595716 8.700421894602961e-07 -0.05234377413999578 +0.3825 0.6171616383688132 0.6171592368947427 8.580703899363495e-07 -0.052354802311882304 +0.3826 0.6171839793034212 0.6171815610814466 8.459401706628622e-07 -0.05236582872970979 +0.38270000000000004 0.6172063157633723 0.6172038810214602 8.336536408692918e-07 -0.05237685339338789 +0.38280000000000003 0.6172286477474901 0.6172261967165413 8.212129381512945e-07 -0.05238787630282641 +0.3829 0.6172509752546185 0.6172485081684279 8.086202274715237e-07 -0.05239889745793539 +0.383 0.6172732982836215 0.617270815378838 7.958777010486084e-07 -0.052409916858625054 +0.3831 0.6172956168333845 0.6172931183494689 7.829875781906193e-07 -0.052420934504805776 +0.38320000000000004 0.6173179309028136 0.6173154170819982 7.699521045179125e-07 -0.0524319503963882 +0.38330000000000003 0.6173402404908361 0.6173377115780823 7.567735517410856e-07 -0.052442964533283065 +0.3834 0.6173625455964011 0.6173600018393562 7.434542173834213e-07 -0.05245397691540139 +0.3835 0.6173848462184791 0.6173822878674347 7.29996424170265e-07 -0.05246498754265432 +0.3836 0.6174071423560629 0.6174045696639098 7.16402519751469e-07 -0.052475996414953235 +0.38370000000000004 0.6174294340081674 0.6174268472303526 7.026748763683255e-07 -0.052487003532209676 +0.38380000000000003 0.6174517211738298 0.617449120568312 6.888158902984554e-07 -0.05249800889433533 +0.3839 0.6174740038521106 0.6174713896793147 6.748279815782521e-07 -0.052509012501242194 +0.384 0.6174962820420924 0.617493654564865 6.607135933922592e-07 -0.05252001435284235 +0.3841 0.6175185557428815 0.6175159152264444 6.464751919066369e-07 -0.0525310144490481 +0.38420000000000004 0.6175408249536073 0.6175381716655121 6.321152654642503e-07 -0.052542012789771976 +0.38430000000000003 0.6175630896734228 0.6175604238835036 6.176363245846694e-07 -0.05255300937492662 +0.3844 0.6175853499015049 0.6175826718818314 6.030409013257909e-07 -0.052564004204424954 +0.3845 0.6176076056370545 0.6176049156618846 5.883315486454599e-07 -0.052574997278180026 +0.3846 0.6176298568792966 0.6176271552250284 5.735108403043254e-07 -0.05258598859610513 +0.38470000000000004 0.6176521036274802 0.6176493905726044 5.585813702690956e-07 -0.05259697815811363 +0.38480000000000003 0.6176743458808797 0.6176716217059298 5.435457522406928e-07 -0.052607965964119235 +0.3849 0.6176965836387937 0.6176938486262978 5.284066192656756e-07 -0.05261895201403576 +0.385 0.6177188169005455 0.617716071334977 5.131666230839826e-07 -0.05262993630777721 +0.3851 0.6177410456654843 0.6177382898332114 4.978284339068884e-07 -0.05264091884525779 +0.38520000000000004 0.6177632699329838 0.6177605041222204 4.823947399035244e-07 -0.05265189962639192 +0.38530000000000003 0.6177854897024438 0.6177827142031982 4.668682466596463e-07 -0.052662878651094175 +0.3854 0.6178077049732891 0.6178049200773138 4.51251676664155e-07 -0.05267385591927929 +0.3855 0.6178299157449707 0.617827121745711 4.355477689482745e-07 -0.05268483143086225 +0.3856 0.6178521220169654 0.6178493192095086 4.197592786137072e-07 -0.0526958051857582 +0.38570000000000004 0.6178743237887765 0.6178715124697992 4.038889761387443e-07 -0.05270677718388253 +0.38580000000000003 0.617896521059933 0.6178937015276501 3.879396471700991e-07 -0.05271774742515074 +0.3859 0.6179187138299903 0.6179158863841022 3.719140919122843e-07 -0.052728715909478543 +0.386 0.6179409020985306 0.6179380670401707 3.5581512455862274e-07 -0.05273968263678186 +0.3861 0.6179630858651626 0.6179602434968449 3.3964557293042485e-07 -0.05275064760697678 +0.38620000000000004 0.6179852651295222 0.6179824157550871 3.2340827800514393e-07 -0.05276161081997961 +0.38630000000000003 0.6180074398912717 0.6180045838158337 3.071060932224867e-07 -0.05277257227570684 +0.3864 0.6180296101501005 0.6180267476799947 2.907418841374687e-07 -0.05278353197407511 +0.3865 0.6180517759057252 0.6180489073484527 2.7431852786530264e-07 -0.05279448991500127 +0.3866 0.6180739371578898 0.6180710628220643 2.5783891269975934e-07 -0.05280544609840235 +0.38670000000000004 0.6180960939063657 0.6180932141016587 2.413059373984616e-07 -0.05281640052419562 +0.38680000000000003 0.6181182461509515 0.6181153611880387 2.2472251082900074e-07 -0.05282735319229849 +0.3869 0.6181403938914738 0.6181375040819794 2.0809155138606927e-07 -0.052838304102628575 +0.387 0.6181625371277863 0.6181596427842291 1.9141598648492186e-07 -0.05284925325510367 +0.3871 0.6181846758597711 0.6181817772955088 1.7469875209646935e-07 -0.05286020064964177 +0.38720000000000004 0.6182068100873375 0.6182039076165121 1.5794279217828944e-07 -0.05287114628616103 +0.38730000000000003 0.6182289398104228 0.6182260337479053 1.411510581403319e-07 -0.052882090164579856 +0.3874 0.6182510650289927 0.6182481556903271 1.2432650840082937e-07 -0.05289303228481677 +0.3875 0.6182731857430406 0.6182702734443888 1.0747210779996075e-07 -0.05290397264679051 +0.3876 0.6182953019525881 0.6182923870106737 9.059082712106759e-08 -0.05291491125042002 +0.38770000000000004 0.618317413657685 0.6183144963897378 7.368564251472587e-08 -0.05292584809562441 +0.38780000000000003 0.6183395208584093 0.6183366015821091 5.6759535023431784e-08 -0.05293678318232298 +0.3879 0.6183616235548667 0.6183587025882887 3.98154900334291e-08 -0.052947716510435255 +0.388 0.6183837217471922 0.6183807994087487 2.2856496756026856e-08 -0.05295864807988089 +0.3881 0.6184058154355487 0.6184028920439337 5.8855476881003455e-09 -0.05296957789057976 +0.38820000000000005 0.6184279046201273 0.6184249804942608 -1.1094361908325912e-08 -0.05298050594245194 +0.38830000000000003 0.6184499893011478 0.6184470647601188 -2.8080234529964665e-08 -0.05299143223541765 +0.3884 0.6184720694788581 0.6184691448418687 -4.50690709726323e-08 -0.05300235676939735 +0.3885 0.6184941451535347 0.6184912207398436 -6.205787085535215e-08 -0.053013279544311655 +0.3886 0.6185162163254827 0.6185132924543486 -7.904363315356516e-08 -0.053024200560081364 +0.38870000000000005 0.6185382829950358 0.6185353599856607 -9.602335672345003e-08 -0.0530351198166275 +0.38880000000000003 0.6185603451625554 0.6185574233340291 -1.1299404084445797e-07 -0.05304603731387121 +0.3889 0.6185824028284324 0.6185794824996748 -1.2995268573907925e-07 -0.053056953051733906 +0.389 0.6186044559930854 0.618601537482791 -1.4689629311559482e-07 -0.053067867030137154 +0.3891 0.6186265046569617 0.6186235882835429 -1.6382186668328913e-07 -0.05307877924900265 +0.38920000000000005 0.6186485488205369 0.6186456349020678 -1.8072641269975542e-07 -0.05308968970825239 +0.38930000000000003 0.6186705884843158 0.6186676773384749 -1.9760694048784333e-07 -0.053100598407808466 +0.3894 0.6186926236488302 0.6186897155928459 -2.14460462999444e-07 -0.05311150534759323 +0.3895 0.6187146543146416 0.6187117496652343 -2.3128399728733484e-07 -0.05312241052752917 +0.3896 0.6187366804823388 0.618733779555666 -2.4807456507069947e-07 -0.05313331394753898 +0.38970000000000005 0.6187587021525393 0.6187558052641385 -2.6482919327636134e-07 -0.05314421560754552 +0.38980000000000004 0.6187807193258889 0.6187778267906223 -2.815449145210369e-07 -0.05315511550747183 +0.3899 0.6188027320030614 0.61879984413506 -2.982187677219583e-07 -0.05316601364724119 +0.39 0.6188247401847586 0.6188218572973662 -3.148477984993292e-07 -0.05317691002677702 +0.3901 0.618846743871711 0.6188438662774283 -3.3142905981470294e-07 -0.05318780464600296 +0.39020000000000005 0.6188687430646765 0.6188658710751064 -3.479596124358886e-07 -0.05319869750484282 +0.39030000000000004 0.6188907377644408 0.6188878716902327 -3.644365254712456e-07 -0.053209588603220594 +0.3904 0.618912727971818 0.6189098681226124 -3.8085687692479553e-07 -0.05322047794106047 +0.3905 0.6189347136876493 0.6189318603720231 -3.9721775411949434e-07 -0.053231365518286805 +0.3906 0.6189566949128043 0.6189538484382153 -4.1351625437724415e-07 -0.05324225133482419 +0.39070000000000005 0.6189786716481797 0.6189758323209129 -4.297494853727768e-07 -0.05325313539059735 +0.39080000000000004 0.6190006438946994 0.6189978120198123 -4.4591456574427646e-07 -0.05326401768553124 +0.3909 0.6190226116533155 0.6190197875345829 -4.6200862559298006e-07 -0.05327489821955096 +0.391 0.6190445749250066 0.6190417588648672 -4.78028806955022e-07 -0.053285776992581795 +0.3911 0.6190665337107792 0.6190637260102818 -4.939722643287903e-07 -0.05329665400454928 +0.39120000000000005 0.6190884880116663 0.6190856889704162 -5.098361652577932e-07 -0.0533075292553791 +0.39130000000000004 0.6191104378287277 0.6191076477448332 -5.2561769070536e-07 -0.053318402744997065 +0.3914 0.6191323831630505 0.61912960233307 -5.413140357207746e-07 -0.05332927447332928 +0.3915 0.6191543240157487 0.6191515527346368 -5.569224097029535e-07 -0.05334014444030199 +0.3916 0.6191762603879616 0.6191734989490183 -5.724400371637239e-07 -0.05335101264584157 +0.39170000000000005 0.619198192280856 0.619195440975673 -5.878641580470134e-07 -0.053361879089874636 +0.39180000000000004 0.619220119695625 0.619217378814034 -6.031920282700831e-07 -0.05337274377232805 +0.3919 0.6192420426334871 0.6192393124635084 -6.184209202647617e-07 -0.05338360669312878 +0.392 0.6192639610956873 0.6192612419234778 -6.335481233382678e-07 -0.05339446785220395 +0.3921 0.6192858750834962 0.6192831671932989 -6.485709443809773e-07 -0.053405327249480966 +0.39220000000000005 0.61930778459821 0.6193050882723028 -6.634867080745899e-07 -0.05341618488488734 +0.39230000000000004 0.6193296896411503 0.6193270051597957 -6.782927576137743e-07 -0.05342704075835082 +0.3924 0.6193515902136644 0.6193489178550593 -6.929864551363796e-07 -0.05343789486979936 +0.3925 0.6193734863171241 0.6193708263573503 -7.075651819177242e-07 -0.053448747219160965 +0.3926 0.6193953779529265 0.6193927306659011 -7.220263391893855e-07 -0.053459597806363994 +0.39270000000000005 0.6194172651224937 0.6194146307799198 -7.363673485139e-07 -0.053470446631336904 +0.39280000000000004 0.6194391478272717 0.6194365266985904 -7.50585652187219e-07 -0.05348129369400835 +0.3929 0.6194610260687314 0.6194584184210732 -7.646787137105537e-07 -0.05349213899430719 +0.393 0.6194828998483679 0.6194803059465044 -7.786440182344645e-07 -0.05350298253216245 +0.3931 0.6195047691676999 0.6195021892739971 -7.924790730862163e-07 -0.05351382430750338 +0.39320000000000005 0.61952663402827 0.6195240684026411 -8.061814080750906e-07 -0.05352466432025931 +0.39330000000000004 0.6195484944316444 0.619545943331503 -8.197485762417855e-07 -0.05353550257035988 +0.3934 0.619570350379413 0.6195678140596264 -8.33178153858416e-07 -0.0535463390577349 +0.3935 0.6195922018731878 0.6195896805860325 -8.464677412334254e-07 -0.053557173782314255 +0.3936 0.6196140489146047 0.61961154290972 -8.596149629891414e-07 -0.05356800674402812 +0.39370000000000005 0.6196358915053216 0.6196334010296654 -8.726174685058652e-07 -0.05357883794280682 +0.39380000000000004 0.6196577296470195 0.6196552549448232 -8.854729322826937e-07 -0.053589667378580896 +0.39390000000000003 0.619679563341401 0.6196771046541264 -8.981790544371204e-07 -0.05360049505128102 +0.394 0.6197013925901909 0.6196989501564865 -9.107335611213685e-07 -0.05361132096083807 +0.3941 0.6197232173951356 0.6197207914507934 -9.231342050219915e-07 -0.05362214510718319 +0.39420000000000005 0.619745037758003 0.6197426285359163 -9.353787655819179e-07 -0.053632967490247554 +0.3943 0.6197668536805824 0.6197644614107038 -9.474650493890291e-07 -0.053643788109962634 +0.39440000000000003 0.6197886651646837 0.6197862900739834 -9.593908908422932e-07 -0.053654606966260024 +0.3945 0.6198104722121378 0.6198081145245634 -9.71154152235032e-07 -0.0536654240590716 +0.3946 0.6198322748247961 0.6198299347612312 -9.827527244210543e-07 -0.05367623938832933 +0.39470000000000005 0.6198540730045298 0.619851750782755 -9.941845268979232e-07 -0.05368705295396542 +0.3948 0.61987586675323 0.6198735625878835 -1.005447508445334e-06 -0.053697864755912185 +0.39490000000000003 0.619897656072808 0.6198953701753462 -1.01653964740267e-06 -0.05370867479410222 +0.395 0.6199194409651938 0.6199171735438537 -1.0274589518077804e-06 -0.05371948306846824 +0.3951 0.6199412214323369 0.6199389726920976 -1.038203460396181e-06 -0.05373028957894317 +0.39520000000000005 0.6199629974762051 0.6199607676187525 -1.0487712422124762e-06 -0.05374109432546015 +0.3953 0.6199847690987853 0.6199825583224735 -1.0591603973597596e-06 -0.053751897307952407 +0.39540000000000003 0.620006536302082 0.6200043448018988 -1.0693690574159476e-06 -0.05376269852635346 +0.3955 0.6200282990881181 0.6200261270556492 -1.0793953853782678e-06 -0.053773497980596954 +0.3956 0.6200500574589338 0.6200479050823279 -1.0892375764681717e-06 -0.05378429567061676 +0.39570000000000005 0.6200718114165868 0.6200696788805213 -1.0988938580758223e-06 -0.05379509159634688 +0.3958 0.6200935609631517 0.6200914484487998 -1.1083624905094958e-06 -0.05380588575772154 +0.39590000000000003 0.6201153061007197 0.6201132137857173 -1.1176417668845584e-06 -0.05381667815467514 +0.396 0.6201370468313985 0.6201349748898113 -1.126730013650823e-06 -0.05382746878714222 +0.3961 0.6201587831573119 0.6201567317596046 -1.135625590814593e-06 -0.053838257655057634 +0.39620000000000005 0.6201805150805995 0.6201784843936039 -1.144326892327241e-06 -0.05384904475835624 +0.3963 0.6202022426034162 0.6202002327903015 -1.15283234639052e-06 -0.05385983009697323 +0.39640000000000003 0.6202239657279318 0.6202219769481747 -1.1611404155953409e-06 -0.05387061367084389 +0.3965 0.6202456844563315 0.6202437168656867 -1.1692495974768846e-06 -0.053881395479903754 +0.3966 0.6202673987908145 0.6202654525412865 -1.1771584244035793e-06 -0.05389217552408848 +0.39670000000000005 0.6202891087335943 0.6202871839734099 -1.18486546427099e-06 -0.053902953803333965 +0.3968 0.6203108142868983 0.6203089111604787 -1.1923693203075292e-06 -0.05391373031757627 +0.39690000000000003 0.6203325154529671 0.6203306341009023 -1.1996686318516137e-06 -0.05392450506675161 +0.397 0.6203542122340543 0.6203523527930768 -1.206762074212886e-06 -0.05393527805079641 +0.3971 0.6203759046324268 0.6203740672353866 -1.2136483590607927e-06 -0.053946049269647245 +0.39720000000000005 0.6203975926503635 0.6203957774262037 -1.2203262346188737e-06 -0.05395681872324096 +0.3973 0.6204192762901559 0.6204174833638887 -1.2267944858590507e-06 -0.05396758641151448 +0.39740000000000003 0.6204409555541068 0.6204391850467909 -1.233051934945717e-06 -0.05397835233440499 +0.3975 0.6204626304445306 0.6204608824732487 -1.2390974411802258e-06 -0.05398911649184987 +0.3976 0.6204843009637526 0.6204825756415897 -1.2449299014727355e-06 -0.05399987888378656 +0.39770000000000005 0.6205059671141091 0.6205042645501311 -1.2505482503144538e-06 -0.054010639510152794 +0.3978 0.6205276288979462 0.6205259491971812 -1.2559514601107047e-06 -0.054021398370886486 +0.39790000000000003 0.6205492863176207 0.6205476295810376 -1.261138541208684e-06 -0.054032155465925706 +0.398 0.6205709393754986 0.6205693056999892 -1.2661085425358376e-06 -0.054042910795208704 +0.3981 0.6205925880739553 0.6205909775523165 -1.2708605511280169e-06 -0.05405366435867396 +0.39820000000000005 0.620614232415375 0.620612645136291 -1.2753936927123455e-06 -0.05406441615626004 +0.3983 0.6206358724021501 0.6206343084501762 -1.2797071319015085e-06 -0.054075166187905754 +0.39840000000000003 0.6206575080366823 0.6206559674922278 -1.2838000722215082e-06 -0.05408591445355011 +0.3985 0.62067913932138 0.6206776222606949 -1.287671756278197e-06 -0.05409666095313231 +0.3986 0.6207007662586594 0.6206992727538185 -1.2913214659238115e-06 -0.05410740568659165 +0.39870000000000005 0.6207223888509442 0.620720918969834 -1.2947485221737054e-06 -0.05411814865386773 +0.3988 0.620744007100664 0.6207425609069696 -1.2979522859279946e-06 -0.05412888985490021 +0.39890000000000003 0.6207656210102553 0.6207641985634484 -1.3009321574442012e-06 -0.054139629289629024 +0.399 0.6207872305821603 0.6207858319374878 -1.3036875768368539e-06 -0.054150366957994245 +0.3991 0.6208088358188273 0.6208074610273003 -1.3062180240219767e-06 -0.05416110285993623 +0.39920000000000005 0.6208304367227088 0.6208290858310931 -1.308523018994645e-06 -0.05417183699539531 +0.3993 0.620852033296263 0.6208507063470694 -1.3106021216902075e-06 -0.05418256936431222 +0.39940000000000003 0.6208736255419521 0.6208723225734285 -1.3124549320953083e-06 -0.054193299966627674 +0.3995 0.6208952134622427 0.6208939345083657 -1.3140810907474876e-06 -0.054204028802282755 +0.3996 0.620916797059605 0.6209155421500735 -1.315480278318848e-06 -0.0542147558712186 +0.39970000000000006 0.6209383763365119 0.6209371454967414 -1.3166522157548322e-06 -0.05422548117337658 +0.3998 0.6209599512954403 0.6209587445465563 -1.3175966645240234e-06 -0.05423620470869828 +0.39990000000000003 0.620981521938869 0.6209803392977034 -1.3183134266459007e-06 -0.05424692647712544 +0.4 0.6210030882692792 0.6210019297483658 -1.3188023446075725e-06 -0.05425764647859993 +0.4001 0.6210246502891532 0.6210235158967256 -1.3190633014470432e-06 -0.05426836471306386 +0.40020000000000006 0.6210462080009758 0.6210450977409632 -1.3190962209197465e-06 -0.05427908118045949 +0.4003 0.6210677614072315 0.6210666752792595 -1.3189010673597679e-06 -0.054289795880729276 +0.40040000000000003 0.621089310510407 0.6210882485097946 -1.3184778456520885e-06 -0.05430050881381587 +0.4005 0.621110855312988 0.6211098174307492 -1.3178266014823858e-06 -0.05431121997966212 +0.4006 0.6211323958174606 0.6211313820403044 -1.3169474210872334e-06 -0.05432192937821101 +0.40070000000000006 0.6211539320263102 0.621152942336642 -1.3158404313651229e-06 -0.05433263700940573 +0.4008 0.6211754639420214 0.6211744983179455 -1.3145057998764642e-06 -0.05434334287318964 +0.40090000000000003 0.6211969915670774 0.6211960499824002 -1.312943734954608e-06 -0.05435404696950631 +0.401 0.62121851490396 0.6212175973281933 -1.3111544853172674e-06 -0.05436474929829946 +0.4011 0.6212400339551483 0.6212391403535147 -1.3091383403718293e-06 -0.054375449859512974 +0.40120000000000006 0.6212615487231194 0.6212606790565572 -1.3068956300765766e-06 -0.054386148653090965 +0.4013 0.621283059210348 0.6212822134355168 -1.304426724635377e-06 -0.05439684567897773 +0.40140000000000003 0.621304565419305 0.6213037434885933 -1.3017320350805495e-06 -0.05440754093711775 +0.4015 0.6213260673524578 0.6213252692139902 -1.298812012440198e-06 -0.05441823442745563 +0.4016 0.6213475650122696 0.6213467906099159 -1.295667148126789e-06 -0.05442892614993619 +0.40170000000000006 0.6213690584011999 0.6213683076745834 -1.292297973937151e-06 -0.05443961610450446 +0.4018 0.621390547521703 0.6213898204062109 -1.2887050615806306e-06 -0.0544503042911056 +0.40190000000000003 0.6214120323762281 0.6214113288030219 -1.28488902281787e-06 -0.05446099070968499 +0.402 0.6214335129672189 0.6214328328632461 -1.2808505095718292e-06 -0.05447167536018815 +0.4021 0.6214549892971135 0.6214543325851201 -1.2765902133726748e-06 -0.05448235824256085 +0.40220000000000006 0.6214764613683434 0.6214758279668862 -1.2721088654965573e-06 -0.05449303935674898 +0.4023 0.6214979291833338 0.6214973190067943 -1.2674072369933675e-06 -0.054503718702698614 +0.40240000000000004 0.6215193927445024 0.6215188057031016 -1.262486138214891e-06 -0.05451439628035604 +0.4025 0.62154085205426 0.6215402880540737 -1.2573464188980754e-06 -0.054525072089667725 +0.4026 0.6215623071150097 0.6215617660579831 -1.2519889679429852e-06 -0.054535746130580244 +0.40270000000000006 0.6215837579291461 0.6215832397131121 -1.2464147133850467e-06 -0.05454641840304047 +0.4028 0.6216052044990557 0.6216047090177517 -1.240624622061981e-06 -0.05455708890699536 +0.40290000000000004 0.6216266468271157 0.6216261739702018 -1.2346196995582925e-06 -0.05456775764239211 +0.403 0.6216480849156945 0.6216476345687724 -1.2284009901220028e-06 -0.054578424609178104 +0.4031 0.6216695187671507 0.6216690908117832 -1.2219695761650495e-06 -0.054589089807300845 +0.40320000000000006 0.6216909483838331 0.6216905426975649 -1.2153265785130873e-06 -0.054599753236708085 +0.4033 0.6217123737680799 0.621711990224458 -1.2084731560169093e-06 -0.054610414897347685 +0.40340000000000004 0.6217337949222188 0.6217334333908149 -1.2014105053304025e-06 -0.05462107478916774 +0.4035 0.6217552118485665 0.6217548721949993 -1.19413986052197e-06 -0.05463173291211648 +0.4036 0.6217766245494285 0.6217763066353865 -1.1866624930745306e-06 -0.05464238926614241 +0.40370000000000006 0.6217980330270982 0.6217977367103644 -1.1789797119965417e-06 -0.05465304385119412 +0.4038 0.621819437283857 0.6218191624183331 -1.1710928629893314e-06 -0.05466369666722039 +0.40390000000000004 0.6218408373219738 0.6218405837577059 -1.1630033284748542e-06 -0.054674347714170214 +0.404 0.621862233143705 0.6218620007269091 -1.1547125274014025e-06 -0.054684996991992744 +0.4041 0.6218836247512933 0.6218834133243825 -1.1462219150215613e-06 -0.054695644500637325 +0.40420000000000006 0.6219050121469688 0.6219048215485803 -1.1375329825591418e-06 -0.054706290240053516 +0.4043 0.6219263953329471 0.6219262253979707 -1.1286472569038697e-06 -0.054716934210191 +0.40440000000000004 0.6219477743114297 0.6219476248710363 -1.1195663004170964e-06 -0.054727576410999616 +0.4045 0.6219691490846035 0.621969019966275 -1.1102917108207766e-06 -0.05473821684242948 +0.4046 0.621990519654641 0.6219904106821998 -1.1008251206701125e-06 -0.05474885550443081 +0.40470000000000006 0.6220118860236992 0.6220117970173394 -1.0911681970204867e-06 -0.054759492396954004 +0.4048 0.6220332481939198 0.6220331789702385 -1.0813226415662403e-06 -0.054770127519949724 +0.40490000000000004 0.6220546061674285 0.6220545565394578 -1.0712901899745386e-06 -0.05478076087336872 +0.405 0.6220759599463348 0.6220759297235748 -1.061072611358016e-06 -0.05479139245716194 +0.4051 0.622097309532732 0.622097298521184 -1.0506717087188644e-06 -0.054802022271280504 +0.40520000000000006 0.6221186549286966 0.622118662930897 -1.0400893180328996e-06 -0.054812650315675795 +0.4053 0.6221399961362876 0.6221400229513427 -1.0293273080275167e-06 -0.05482327659029926 +0.40540000000000004 0.6221613331575471 0.6221613785811687 -1.0183875800706677e-06 -0.054833901095102625 +0.4055 0.6221826659944989 0.6221827298190399 -1.007272067476972e-06 -0.0548445238300377 +0.4056 0.6222039946491495 0.6222040766636399 -9.959827354522055e-07 -0.05485514479505654 +0.40570000000000006 0.6222253191234867 0.622225419113671 -9.845215808157448e-07 -0.05486576399011137 +0.4058 0.6222466394194792 0.6222467571678552 -9.728906313899444e-07 -0.05487638141515458 +0.40590000000000004 0.6222679555390779 0.6222680908249332 -9.610919458058476e-07 -0.05488699707013875 +0.406 0.6222892674842134 0.6222894200836652 -9.491276130868531e-07 -0.05489761095501662 +0.4061 0.6223105752567974 0.6223107449428322 -9.369997522878926e-07 -0.05490822306974117 +0.40620000000000006 0.6223318788587217 0.6223320654012348 -9.247105122178745e-07 -0.054918833414265456 +0.4063 0.6223531782918578 0.622353381457694 -9.122620709123286e-07 -0.0549294419885428 +0.40640000000000004 0.6223744735580572 0.6223746931110522 -8.996566354391167e-07 -0.05494004879252667 +0.4065 0.6223957646591504 0.6223960003601722 -8.868964412045433e-07 -0.05495065382617068 +0.4066 0.6224170515969474 0.6224173032039387 -8.739837519256e-07 -0.05496125708942872 +0.40670000000000006 0.6224383343732367 0.6224386016412577 -8.609208589915873e-07 -0.05497185858225476 +0.4068 0.6224596129897856 0.6224598956710572 -8.477100811032923e-07 -0.054982458304602966 +0.40690000000000004 0.6224808874483396 0.6224811852922871 -8.343537638011433e-07 -0.05499305625642773 +0.407 0.6225021577506226 0.6225024705039203 -8.208542793541884e-07 -0.05500365243768364 +0.4071 0.6225234238983356 0.6225237513049514 -8.072140259274274e-07 -0.05501424684832537 +0.40720000000000006 0.6225446858931577 0.6225450276943987 -7.934354274152788e-07 -0.05502483948830783 +0.4073 0.6225659437367452 0.6225662996713033 -7.795209330252462e-07 -0.055035430357586096 +0.40740000000000004 0.6225871974307313 0.6225875672347297 -7.654730167783175e-07 -0.05504601945611542 +0.4075 0.6226084469767261 0.622608830383766 -7.512941769260983e-07 -0.05505660678385124 +0.4076 0.6226296923763166 0.6226300891175242 -7.369869356732561e-07 -0.05506719234074917 +0.40770000000000006 0.6226509336310659 0.6226513434351403 -7.225538388999642e-07 -0.05507777612676504 +0.4078 0.6226721707425132 0.6226725933357745 -7.079974553569901e-07 -0.055088358141854754 +0.40790000000000004 0.622693403712174 0.6226938388186118 -6.933203764020179e-07 -0.055098938385974544 +0.408 0.6227146325415388 0.6227150798828618 -6.78525215541681e-07 -0.055109516859080665 +0.4081 0.6227358572320743 0.6227363165277591 -6.63614607904206e-07 -0.05512009356112965 +0.40820000000000006 0.622757077785222 0.6227575487525627 -6.485912097814461e-07 -0.05513066849207818 +0.4083 0.6227782942023992 0.6227787765565584 -6.334576983513251e-07 -0.055141241651883124 +0.40840000000000004 0.6227995064849973 0.6227999999390563 -6.182167708451702e-07 -0.05515181304050152 +0.4085 0.6228207146343827 0.622821218899393 -6.028711443673007e-07 -0.05516238265789058 +0.4086 0.6228419186518965 0.6228424334369305 -5.87423555242772e-07 -0.0551729505040077 +0.40870000000000006 0.6228631185388538 0.6228636435510571 -5.718767586426754e-07 -0.05518351657881043 +0.4088 0.6228843142965443 0.6228848492411871 -5.562335279873931e-07 -0.05519408088225656 +0.40890000000000004 0.6229055059262312 0.6229060505067623 -5.404966546274093e-07 -0.055204643414304005 +0.409 0.6229266934291516 0.62292724734725 -5.246689471771759e-07 -0.05521520417491086 +0.4091 0.6229478768065166 0.6229484397621445 -5.087532309600018e-07 -0.055225763164035414 +0.40920000000000006 0.6229690560595107 0.6229696277509678 -4.927523478415186e-07 -0.05523632038163615 +0.4093 0.622990231189291 0.622990811313268 -4.766691552721136e-07 -0.05524687582767166 +0.40940000000000004 0.6230114021969888 0.6230119904486211 -4.6050652612039666e-07 -0.05525742950210079 +0.4095 0.6230325690837075 0.6230331651566304 -4.4426734807645474e-07 -0.05526798140488252 +0.4096 0.6230537318505243 0.6230543354369268 -4.2795452301347403e-07 -0.05527853153597602 +0.40970000000000006 0.6230748904984884 0.6230755012891688 -4.115709666269174e-07 -0.05528907989534067 +0.4098 0.6230960450286219 0.6230966627130426 -3.9511960785165723e-07 -0.05529962648293594 +0.40990000000000004 0.6231171954419196 0.6231178197082629 -3.7860338826523066e-07 -0.055310171298721594 +0.41 0.6231383417393483 0.6231389722745716 -3.6202526175477256e-07 -0.055320714342657465 +0.4101 0.6231594839218475 0.6231601204117394 -3.453881937606762e-07 -0.05533125561470364 +0.41020000000000006 0.6231806219903279 0.6231812641195652 -3.2869516095740403e-07 -0.055341795114820305 +0.4103 0.6232017559456733 0.6232024033978762 -3.119491505387817e-07 -0.05535233284296792 +0.41040000000000004 0.6232228857887389 0.6232235382465284 -2.95153159822481e-07 -0.05536286879910705 +0.4105 0.6232440115203519 0.6232446686654061 -2.783101956324585e-07 -0.05537340298319848 +0.4106 0.6232651331413109 0.6232657946544221 -2.6142327377853825e-07 -0.0553839353952031 +0.41070000000000007 0.6232862506523866 0.6232869162135186 -2.4449541857068935e-07 -0.05539446603508206 +0.4108 0.623307364054321 0.6233080333426664 -2.2752966214595327e-07 -0.055404994902796656 +0.41090000000000004 0.6233284733478276 0.6233291460418651 -2.1052904414231577e-07 -0.05541552199830835 +0.411 0.6233495785335915 0.6233502543111433 -1.9349661089379522e-07 -0.05542604732157879 +0.4111 0.6233706796122689 0.623371358150559 -1.7643541512166183e-07 -0.05543657087256979 +0.41120000000000007 0.6233917765844875 0.6233924575601988 -1.5934851523707882e-07 -0.05544709265124337 +0.4113 0.6234128694508462 0.623413552540179 -1.422389748310937e-07 -0.05545761265756169 +0.41140000000000004 0.623433958211915 0.6234346430906452 -1.2510986212993513e-07 -0.055468130891487104 +0.4115 0.6234550428682355 0.6234557292117717 -1.079642494433708e-07 -0.05547864735298215 +0.4116 0.6234761234203194 0.6234768109037628 -9.080521264949459e-08 -0.055489162042009536 +0.41170000000000007 0.62349719986865 0.6234978881668518 -7.363583058236922e-08 -0.05549967495853212 +0.4118 0.6235182722136821 0.6235189610013014 -5.645918452028276e-08 -0.05551018610251297 +0.41190000000000004 0.6235393404558409 0.6235400294074038 -3.927835760461629e-08 -0.05552069547391533 +0.412 0.6235604045955228 0.6235610933854809 -2.209643431812583e-08 -0.055531203072702595 +0.4121 0.623581464633095 0.6235821529358834 -4.91649989773843e-09 -0.05554170889883834 +0.41220000000000007 0.6236025205688962 0.6236032080589922 1.2258360199308982e-08 -0.055552212952286364 +0.4123 0.6236235724032353 0.6236242587552172 2.9425060853183194e-08 -0.05556271523301057 +0.41240000000000004 0.623644620136393 0.6236453050249982 4.658051784567352e-08 -0.05557321574097508 +0.4125 0.6236656637686199 0.6236663468688037 6.372164840229289e-08 -0.05558371447614418 +0.4126 0.6236867033001385 0.6236873842871324 8.084537176517026e-08 -0.05559421143848231 +0.41270000000000007 0.6237077387311423 0.6237084172805122 9.794860971953923e-08 -0.055604706627954165 +0.4128 0.6237287700617953 0.6237294458495002 1.1502828717313562e-07 -0.055615200044524526 +0.41290000000000004 0.6237497972922327 0.6237504699946832 1.3208133270437017e-07 -0.05562569168815839 +0.413 0.6237708204225609 0.6237714897166771 1.4910467911743996e-07 -0.05563618155882091 +0.4131 0.6237918394528574 0.6237925050161272 1.6609526397315388e-07 -0.05564666965647746 +0.41320000000000007 0.623812854383171 0.623813515893708 1.83050030182208e-07 -0.05565715598109351 +0.4133 0.6238338652135214 0.6238345223501234 1.9996592651866374e-07 -0.05566764053263479 +0.41340000000000005 0.6238548719439 0.6238555243861063 2.1683990820281496e-07 -0.055678123311067175 +0.4135 0.623875874574269 0.6238765220024186 2.336689374007883e-07 -0.05568860431635669 +0.4136 0.6238968731045624 0.6238975151998516 2.504499838421048e-07 -0.05569908354846953 +0.41370000000000007 0.6239178675346855 0.6239185039792252 2.671800253470358e-07 -0.05570956100737212 +0.4138 0.6239388578645148 0.6239394883413885 2.838560482568142e-07 -0.05572003669303099 +0.41390000000000005 0.6239598440938992 0.6239604682872191 3.0047504820385207e-07 -0.055730510605412925 +0.414 0.6239808262226589 0.6239814438176232 3.1703403045174605e-07 -0.0557409827444848 +0.4141 0.6240018042505857 0.6240024149335365 3.335300105544725e-07 -0.05575145311021375 +0.41420000000000007 0.6240227781774436 0.6240233816359222 3.4996001482823225e-07 -0.055761921702567 +0.4143 0.6240437480029685 0.6240443439257723 3.663210808996231e-07 -0.055772388521512055 +0.41440000000000005 0.6240647137268683 0.6240653018041077 3.826102583370794e-07 -0.05578285356701649 +0.4145 0.6240856753488231 0.6240862552719766 3.9882460903251093e-07 -0.055793316839048084 +0.4146 0.6241066328684854 0.6241072043304557 4.1496120786743695e-07 -0.05580377833757482 +0.41470000000000007 0.6241275862854803 0.6241281489806499 4.310171431154419e-07 -0.05581423806256483 +0.4148 0.624148535599405 0.6241490892236918 4.4698951712218715e-07 -0.05582469601398642 +0.41490000000000005 0.62416948080983 0.6241700250607415 4.6287544668011105e-07 -0.05583515219180812 +0.415 0.6241904219162986 0.6241909564929871 4.786720636529296e-07 -0.055845606595998576 +0.4151 0.624211358918326 0.6242118835216439 4.943765154891144e-07 -0.055856059226526616 +0.41520000000000007 0.6242322918154024 0.6242328061479542 5.099859656521044e-07 -0.055866510083361236 +0.4153 0.6242532206069893 0.6242537243731883 5.254975942586837e-07 -0.055876959166471674 +0.41540000000000005 0.6242741452925233 0.6242746381986424 5.409085984120487e-07 -0.05588740647582725 +0.4155 0.6242950658714135 0.6242955476256403 5.5621619300672e-07 -0.0558978520113975 +0.4156 0.6243159823430432 0.6243164526555325 5.714176109505864e-07 -0.055908295773152164 +0.41570000000000007 0.6243368947067696 0.6243373532896954 5.86510103789406e-07 -0.05591873776106108 +0.4158 0.6243578029619239 0.6243582495295323 6.014909421508952e-07 -0.05592917797509435 +0.41590000000000005 0.6243787071078116 0.6243791413764723 6.163574163969843e-07 -0.05593961641522216 +0.416 0.624399607143713 0.6244000288319707 6.311068368597406e-07 -0.055950053081414965 +0.4161 0.6244205030688825 0.624420911897508 6.457365346324018e-07 -0.055960487973643315 +0.41620000000000007 0.6244413948825498 0.6244417905745913 6.602438618052986e-07 -0.055970921091877956 +0.4163 0.6244622825839193 0.6244626648647518 6.74626191965455e-07 -0.05598135243608981 +0.41640000000000005 0.624483166172171 0.624483534769547 6.888809208904778e-07 -0.05599178200624999 +0.4165 0.6245040456464603 0.6245044002905586 7.030054667844787e-07 -0.05600220980232974 +0.4166 0.6245249210059183 0.6245252614293935 7.169972709442085e-07 -0.05601263582430058 +0.41670000000000007 0.6245457922496517 0.6245461181876828 7.308537981476348e-07 -0.05602306007213407 +0.4168 0.6245666593767434 0.6245669705670822 7.44572536875987e-07 -0.05603348254580201 +0.41690000000000005 0.6245875223862529 0.624587818569271 7.581510002574454e-07 -0.056043903245276354 +0.417 0.6246083812772163 0.6246086621959531 7.715867262059195e-07 -0.056054322170529275 +0.4171 0.6246292360486463 0.6246295014488554 7.848772777263591e-07 -0.05606473932153309 +0.41720000000000007 0.6246500866995324 0.6246503363297283 7.980202437474215e-07 -0.056075154698260236 +0.4173 0.6246709332288418 0.6246711668403456 8.110132394822944e-07 -0.056085568300683425 +0.41740000000000005 0.6246917756355193 0.6246919929825036 8.238539065397177e-07 -0.05609598012877545 +0.4175 0.6247126139184871 0.6247128147580212 8.365399136456286e-07 -0.05610639018250935 +0.4176 0.6247334480766458 0.6247336321687401 8.490689570872512e-07 -0.056116798461858276 +0.41770000000000007 0.6247542781088741 0.6247544452165241 8.614387608241181e-07 -0.0561272049667956 +0.4178 0.6247751040140295 0.6247752539032583 8.736470774595162e-07 -0.05613760969729486 +0.41790000000000005 0.6247959257909479 0.6247960582308498 8.856916880739529e-07 -0.05614801265332971 +0.418 0.6248167434384447 0.6248168582012271 8.975704029745568e-07 -0.05615841383487402 +0.4181 0.6248375569553145 0.6248376538163395 9.092810619448777e-07 -0.056168813241901885 +0.41820000000000007 0.6248583663403319 0.6248584450781569 9.208215348277538e-07 -0.056179210874387486 +0.4183 0.6248791715922509 0.6248792319886702 9.321897216918451e-07 -0.05618960673230522 +0.41840000000000005 0.6248999727098061 0.62490001454989 9.433835532757229e-07 -0.05620000081562965 +0.4185 0.6249207696917125 0.6249207927638469 9.544009915429807e-07 -0.056210393124335484 +0.4186 0.6249415625366661 0.6249415666325913 9.652400299597907e-07 -0.056220783658397645 +0.41870000000000007 0.6249623512433439 0.6249623361581924 9.758986936614367e-07 -0.056231172417791186 +0.4188 0.6249831358104041 0.6249831013427393 9.863750400906923e-07 -0.056241559402491405 +0.41890000000000005 0.6250039162364869 0.6250038621883389 9.966671591921106e-07 -0.05625194461247371 +0.419 0.6250246925202145 0.6250246186971171 1.0067731739671348e-06 -0.05626232804771367 +0.41910000000000003 0.6250454646601914 0.6250453708712173 1.0166912403630768e-06 -0.056272709708187055 +0.4192000000000001 0.6250662326550047 0.6250661187128013 1.0264195482445615e-06 -0.056283089593869844 +0.4193 0.6250869965032247 0.6250868622240475 1.035956321560061e-06 -0.056293467704738115 +0.41940000000000005 0.6251077562034046 0.6251076014071524 1.0452998180365825e-06 -0.05630384404076812 +0.4195 0.6251285117540816 0.6251283362643285 1.0544483302898922e-06 -0.056314218601936375 +0.41960000000000003 0.6251492631537767 0.625149066797805 1.0634001858522701e-06 -0.056324591388219436 +0.4197000000000001 0.6251700104009954 0.6251697930098276 1.0721537474223108e-06 -0.05633496239959418 +0.4198 0.6251907534942276 0.6251905149026573 1.08070741319799e-06 -0.05634533163603755 +0.41990000000000005 0.6252114924319481 0.6252112324785707 1.0890596171819755e-06 -0.05635569909752667 +0.42 0.625232227212617 0.6252319457398596 1.0972088296812288e-06 -0.05636606478403886 +0.42010000000000003 0.6252529578346802 0.6252526546888306 1.1051535572792481e-06 -0.056376428695551595 +0.4202 0.6252736842965695 0.6252733593278044 1.1128923429748472e-06 -0.05638679083204254 +0.4203 0.6252944065967032 0.6252940596591163 1.1204237670425776e-06 -0.056397151193489516 +0.42040000000000005 0.625315124733486 0.6253147556851152 1.1277464470604848e-06 -0.05640750977987056 +0.4205 0.6253358387053096 0.6253354474081629 1.134859037882352e-06 -0.056417866591163816 +0.42060000000000003 0.6253565485105537 0.6253561348306348 1.1417602319152564e-06 -0.05642822162734759 +0.4207 0.6253772541475849 0.6253768179549186 1.1484487599522364e-06 -0.05643857488840044 +0.4208 0.6253979556147585 0.6253974967834146 1.1549233908392242e-06 -0.05644892637430106 +0.42090000000000005 0.625418652910418 0.6254181713185345 1.1611829316970912e-06 -0.05645927608502824 +0.421 0.625439346032896 0.6254388415627024 1.1672262284490031e-06 -0.05646962402056106 +0.42110000000000003 0.6254600349805141 0.6254595075183529 1.1730521659036874e-06 -0.05647997018087875 +0.4212 0.6254807197515833 0.6254801691879319 1.178659668005233e-06 -0.056490314565960625 +0.4213 0.6255014003444048 0.6255008265738955 1.1840476979163572e-06 -0.05650065717578623 +0.42140000000000005 0.6255220767572702 0.6255214796787099 1.1892152583514726e-06 -0.0565109980103353 +0.4215 0.6255427489884615 0.6255421285048508 1.194161391632198e-06 -0.05652133706958767 +0.42160000000000003 0.6255634170362523 0.6255627730548039 1.198885180075937e-06 -0.05653167435352344 +0.4217 0.6255840808989068 0.6255834133310634 1.2033857460513886e-06 -0.056542009862122794 +0.4218 0.6256047405746821 0.6256040493361319 1.207662252006303e-06 -0.056552343595366164 +0.42190000000000005 0.6256253960618265 0.6256246810725204 1.2117139008838151e-06 -0.05656267555323407 +0.422 0.6256460473585814 0.6256453085427482 1.2155399359836672e-06 -0.056573005735707296 +0.42210000000000003 0.6256666944631815 0.6256659317493414 1.2191396414895639e-06 -0.05658333414276673 +0.4222 0.6256873373738538 0.625686550694833 1.2225123423581508e-06 -0.05659366077439343 +0.4223 0.6257079760888202 0.6257071653817634 1.2256574044855473e-06 -0.05660398563056865 +0.42240000000000005 0.6257286106062963 0.6257277758126785 1.228574234762858e-06 -0.0566143087112738 +0.4225 0.625749240924492 0.6257483819901305 1.2312622811871954e-06 -0.05662463001649048 +0.42260000000000003 0.6257698670416126 0.6257689839166772 1.2337210334723014e-06 -0.05663494954620044 +0.4227 0.6257904889558583 0.6257895815948811 1.235950022437926e-06 -0.05664526730038562 +0.4228 0.625811106665425 0.6258101750273095 1.2379488202596267e-06 -0.05665558327902809 +0.42290000000000005 0.6258317201685053 0.6258307642165339 1.239717040829591e-06 -0.05666589748211009 +0.423 0.6258523294632876 0.6258513491651305 1.2412543398399034e-06 -0.05667620990961414 +0.42310000000000003 0.6258729345479578 0.6258719298756776 1.2425604145049896e-06 -0.05668652056152277 +0.4232 0.6258935354206985 0.6258925063507579 1.2436350040612165e-06 -0.056696829437818785 +0.4233 0.6259141320796906 0.6259130785929562 1.244477889433826e-06 -0.056707136538485185 +0.42340000000000005 0.6259347245231126 0.6259336466048595 1.2450888934867343e-06 -0.05671744186350497 +0.4235 0.6259553127491417 0.625954210389057 1.2454678809947772e-06 -0.05672774541286155 +0.42360000000000003 0.6259758967559541 0.6259747699481397 1.245614758865754e-06 -0.0567380471865383 +0.4237 0.625996476541725 0.6259953252846988 1.2455294759738944e-06 -0.05674834718451889 +0.4238 0.6260170521046295 0.626015876401327 1.2452120231043473e-06 -0.05675864540678708 +0.42390000000000005 0.6260376234428429 0.626036423300617 1.2446624333140033e-06 -0.05676894185332684 +0.424 0.6260581905545404 0.6260569659851618 1.2438807813486275e-06 -0.05677923652412229 +0.42410000000000003 0.6260787534378989 0.6260775044575533 1.2428671841147043e-06 -0.05678952941915776 +0.4242 0.6260993120910963 0.6260980387203826 1.24162180079046e-06 -0.05679982053841773 +0.4243 0.626119866512312 0.6261185687762403 1.2401448324927955e-06 -0.05681010988188683 +0.42440000000000005 0.6261404166997276 0.6261390946277141 1.2384365221385085e-06 -0.056820397449549837 +0.4245 0.6261609626515272 0.6261596162773908 1.2364971546108272e-06 -0.05683068324139178 +0.42460000000000003 0.6261815043658977 0.6261801337278539 1.2343270568149212e-06 -0.05684096725739777 +0.4247 0.6262020418410297 0.6262006469816843 1.2319265975391236e-06 -0.05685124949755316 +0.4248 0.6262225750751167 0.6262211560414596 1.2292961872883978e-06 -0.056861529961843404 +0.42490000000000006 0.6262431040663573 0.6262416609097536 1.2264362784231153e-06 -0.05687180865025421 +0.425 0.6262636288129536 0.6262621615891362 1.2233473649370108e-06 -0.0568820855627713 +0.42510000000000003 0.6262841493131135 0.6262826580821726 1.2200299821241156e-06 -0.0568923606993808 +0.4252 0.626304665565049 0.6263031503914234 1.2164847071616247e-06 -0.05690263406006875 +0.4253 0.6263251775669793 0.626323638519444 1.2127121583327405e-06 -0.05691290564482157 +0.42540000000000006 0.6263456853171281 0.6263441224687833 1.2087129954430065e-06 -0.05692317545362568 +0.4255 0.6263661888137267 0.6263646022419855 1.2044879195427516e-06 -0.05693344348646783 +0.42560000000000003 0.6263866880550131 0.6263850778415873 1.200037672538512e-06 -0.056943709743334826 +0.4257 0.6264071830392319 0.6264055492701188 1.1953630373040536e-06 -0.05695397422421366 +0.4258 0.6264276737646358 0.626426016530103 1.1904648376248606e-06 -0.05696423692909152 +0.42590000000000006 0.6264481602294856 0.6264464796240552 1.185343937976091e-06 -0.05697449785795573 +0.426 0.6264686424320502 0.6264669385544825 1.1800012432450213e-06 -0.0569847570107938 +0.42610000000000003 0.626489120370608 0.6264873933238843 1.1744376987865568e-06 -0.05699501438759345 +0.4262 0.6265095940434453 0.6265078439347501 1.1686542902566988e-06 -0.05700526998834248 +0.4263 0.6265300634488593 0.6265282903895611 1.162652043112944e-06 -0.05701552381302891 +0.42640000000000006 0.6265505285851565 0.6265487326907888 1.1564320230028624e-06 -0.057025775861640954 +0.4265 0.6265709894506536 0.6265691708408947 1.1499953347648972e-06 -0.057036026134166896 +0.42660000000000003 0.6265914460436783 0.6265896048423296 1.1433431230667424e-06 -0.057046274630595334 +0.4267 0.6266118983625695 0.6266100346975341 1.1364765720445202e-06 -0.05705652135091488 +0.4268 0.6266323464056771 0.6266304604089379 1.1293969045256258e-06 -0.05706676629511447 +0.42690000000000006 0.6266527901713632 0.6266508819789587 1.12210538244506e-06 -0.05707700946318305 +0.427 0.626673229658002 0.6266712994100025 1.1146033063180738e-06 -0.05708725085510984 +0.42710000000000004 0.6266936648639803 0.6266917127044637 1.1068920151569017e-06 -0.05709749047088422 +0.4272 0.6267140957876978 0.6267121218647235 1.0989728859711612e-06 -0.05710772831049569 +0.4273 0.6267345224275676 0.6267325268931505 1.0908473337956082e-06 -0.057117964373933953 +0.42740000000000006 0.6267549447820161 0.6267529277921 1.0825168115513595e-06 -0.05712819866118884 +0.4275 0.6267753628494842 0.6267733245639137 1.0739828094075143e-06 -0.05713843117225042 +0.42760000000000004 0.6267957766284269 0.626793717210919 1.0652468547811544e-06 -0.05714866190710885 +0.4277 0.6268161861173142 0.6268141057354295 1.0563105120597882e-06 -0.05715889086575452 +0.4278 0.6268365913146309 0.6268344901397438 1.0471753821850172e-06 -0.05716911804817797 +0.42790000000000006 0.6268569922188774 0.6268548704261453 1.0378431025415136e-06 -0.057179343454369896 +0.428 0.6268773888285698 0.6268752465969023 1.0283153464574202e-06 -0.05718956708432113 +0.42810000000000004 0.6268977811422403 0.6268956186542674 1.0185938229267943e-06 -0.0571997889380227 +0.4282 0.6269181691584375 0.6269159866004766 1.0086802767761416e-06 -0.05721000901546583 +0.4283 0.6269385528757273 0.6269363504377503 9.985764876374592e-07 -0.05722022731664187 +0.42840000000000006 0.6269589322926922 0.6269567101682915 9.8828427036457e-07 -0.05723044384154237 +0.4285 0.6269793074079322 0.6269770657942862 9.778054740339215e-07 -0.05724065859015899 +0.42860000000000004 0.6269996782200656 0.6269974173179036 9.671419819168303e-07 -0.05725087156248365 +0.4287 0.6270200447277285 0.627017764741294 9.562957113129489e-07 -0.057261082758508365 +0.4288 0.6270404069295754 0.627038108066591 9.45268612911887e-07 -0.057271292178225346 +0.42890000000000006 0.6270607648242797 0.6270584472959086 9.340626705711674e-07 -0.057281499821626926 +0.429 0.6270811184105337 0.6270787824313427 9.226799009831588e-07 -0.05729170568870565 +0.42910000000000004 0.6271014676870494 0.6270991134749702 9.111223533975199e-07 -0.05730190977945421 +0.4292 0.6271218126525583 0.6271194404288485 8.993921091493551e-07 -0.057312112093865476 +0.4293 0.627142153305812 0.6271397632950155 8.874912811041025e-07 -0.05732231263193249 +0.42940000000000006 0.6271624896455826 0.627160082075489 8.754220137130453e-07 -0.057332511393648436 +0.4295 0.6271828216706627 0.6271803967722669 8.631864822639113e-07 -0.05734270837900673 +0.42960000000000004 0.6272031493798658 0.6272007073873259 8.507868926865836e-07 -0.05735290358800082 +0.4297 0.6272234727720263 0.6272210139226225 8.382254809979894e-07 -0.05736309702062445 +0.4298 0.6272437918460005 0.6272413163800921 8.25504512969033e-07 -0.05737328867687146 +0.42990000000000006 0.6272641066006668 0.6272616147616481 8.126262837915288e-07 -0.057383478556735916 +0.43 0.6272844170349248 0.6272819090691829 7.995931177173787e-07 -0.05739366666021198 +0.43010000000000004 0.6273047231476973 0.6273021993045664 7.864073675867278e-07 -0.05740385298729403 +0.4302 0.6273250249379292 0.6273224854696466 7.730714142173412e-07 -0.05741403753797658 +0.4303 0.6273453224045886 0.627342767566249 7.595876661270484e-07 -0.05742422031225435 +0.43040000000000006 0.6273656155466665 0.6273630455961762 7.459585590341433e-07 -0.05743440131012219 +0.4305 0.6273859043631775 0.6273833195612077 7.321865556908502e-07 -0.05744458053157512 +0.43060000000000004 0.6274061888531597 0.6274035894630998 7.182741451339236e-07 -0.05745475797660831 +0.4307 0.6274264690156754 0.6274238553035856 7.042238423793368e-07 -0.05746493364521718 +0.4308 0.6274467448498104 0.6274441170843739 6.900381877839035e-07 -0.057475107537397145 +0.43090000000000006 0.627467016354676 0.6274643748071494 6.757197469620113e-07 -0.05748527965314396 +0.431 0.6274872835294074 0.6274846284735732 6.612711099251989e-07 -0.057495449992453485 +0.43110000000000004 0.6275075463731649 0.6275048780852812 6.466948908878667e-07 -0.05750561855532175 +0.4312 0.6275278048851338 0.6275251236438851 6.319937276844101e-07 -0.05751578534174489 +0.4313 0.627548059064525 0.6275453651509711 6.171702812418633e-07 -0.05752595035171927 +0.43140000000000006 0.6275683089105748 0.6275656026081007 6.022272352051994e-07 -0.057536113585241425 +0.4315 0.6275885544225454 0.6275858360168097 5.871672954793627e-07 -0.057546275042308005 +0.43160000000000004 0.6276087955997247 0.6276060653786083 5.719931896047692e-07 -0.057556434722915856 +0.43170000000000003 0.6276290324414273 0.627626290694981 5.567076663270942e-07 -0.05756659262706202 +0.4318 0.6276492649469936 0.6276465119673863 5.413134951115506e-07 -0.05757674875474361 +0.43190000000000006 0.6276694931157912 0.6276667291972563 5.258134656849212e-07 -0.05758690310595802 +0.432 0.6276897169472142 0.627686942385997 5.102103874943253e-07 -0.05759705568070274 +0.43210000000000004 0.627709936440684 0.6277071515349874 4.945070892631298e-07 -0.05760720647897544 +0.43220000000000003 0.6277301515956487 0.6277273566455799 4.787064182137923e-07 -0.05761735550077397 +0.4323 0.627750362411584 0.6277475577190996 4.62811239929084e-07 -0.057627502746096286 +0.4324 0.6277705688879933 0.6277677547568452 4.468244376304442e-07 -0.057637648214940586 +0.4325 0.6277907710244075 0.6277879477600874 4.307489116367469e-07 -0.05764779190730517 +0.43260000000000004 0.6278109688203857 0.6278081367300696 4.1458757883694464e-07 -0.05765793382318858 +0.43270000000000003 0.6278311622755142 0.6278283216680078 3.983433723292462e-07 -0.05766807396258942 +0.4328 0.6278513513894082 0.6278485025750898 3.82019240671716e-07 -0.05767821232550653 +0.4329 0.6278715361617111 0.6278686794524757 3.656181475353293e-07 -0.05768834891193889 +0.433 0.6278917165920949 0.6278888523012975 3.491430710378385e-07 -0.05769848372188568 +0.43310000000000004 0.6279118926802598 0.627909021122659 3.325970032719283e-07 -0.05770861675534618 +0.43320000000000003 0.6279320644259354 0.6279291859176352 3.1598294970847096e-07 -0.057718748012319854 +0.4333 0.6279522318288794 0.6279493466872732 2.993039286969257e-07 -0.05772887749280639 +0.4334 0.6279723948888791 0.6279695034325912 2.8256297095186067e-07 -0.057739005196805575 +0.4335 0.6279925536057507 0.6279896561545787 2.6576311878967473e-07 -0.05774913112431734 +0.43360000000000004 0.6280127079793395 0.6280098048541962 2.489074258996138e-07 -0.057759255275341884 +0.43370000000000003 0.6280328580095205 0.6280299495323758 2.319989566013092e-07 -0.05776937764987949 +0.4338 0.6280530036961977 0.6280500901900196 2.1504078524109405e-07 -0.057779498247930584 +0.4339 0.6280731450393049 0.6280702268280014 1.9803599579648612e-07 -0.05778961706949581 +0.434 0.6280932820388057 0.6280903594471654 1.8098768118923747e-07 -0.057799734114576 +0.43410000000000004 0.628113414694693 0.6281104880483264 1.6389894277879513e-07 -0.05780984938317203 +0.43420000000000003 0.62813354300699 0.6281306126322698 1.4677288977249514e-07 -0.0578199628752851 +0.4343 0.6281536669757493 0.6281507331997513 1.2961263868432882e-07 -0.05783007459091641 +0.4344 0.6281737866010538 0.6281708497514976 1.1242131271391176e-07 -0.05784018453006745 +0.4345 0.6281939018830164 0.6281909622882055 9.520204123300569e-08 -0.05785029269273981 +0.43460000000000004 0.6282140128217798 0.6282110708105417 7.795795923387638e-08 -0.0578603990789353 +0.43470000000000003 0.628234119417517 0.6282311753191437 6.069220668050712e-08 -0.05787050368865582 +0.4348 0.628254221670431 0.6282512758146191 4.340792800205939e-08 -0.05788060652190348 +0.4349 0.6282743195807553 0.6282713722975454 2.6108271506536385e-08 -0.05789070757868051 +0.435 0.6282944131487537 0.6282914647684704 8.796388789242271e-09 -0.05790080685898938 +0.43510000000000004 0.62831450237472 0.6283115532279119 -8.524565836207088e-09 -0.05791090436283265 +0.43520000000000003 0.6283345872589785 0.6283316376763578 -2.5851435904271358e-08 -0.05792100009021309 +0.4353 0.6283546678018838 0.6283517181142662 -4.318106337341393e-08 -0.057931094041133585 +0.4354 0.6283747440038207 0.628371794542065 -6.051028921113741e-08 -0.0579411862155972 +0.4355 0.6283948158652046 0.628391866960152 -7.783595396514131e-08 -0.05795127661360722 +0.43560000000000004 0.6284148833864813 0.6284119353688955 -9.515489833925028e-08 -0.05796136523516702 +0.43570000000000003 0.6284349465681267 0.6284319997686334 -1.1246396377541379e-07 -0.05797145208028018 +0.4358 0.6284550054106472 0.6284520601596736 -1.2975999302659857e-07 -0.05798153714895039 +0.4359 0.6284750599145797 0.6284721165422941 -1.47039830717538e-07 -0.05799162044118155 +0.436 0.6284951100804913 0.6284921689167432 -1.6430032396749783e-07 -0.058001701956977736 +0.43610000000000004 0.6285151559089796 0.6285122172832388 -1.8153832290895844e-07 -0.05801178169634318 +0.43620000000000003 0.6285351974006719 0.6285322616419694 -1.9875068131211537e-07 -0.05802185965928223 +0.4363 0.6285552345562266 0.6285523019930933 -2.1593425713478664e-07 -0.058031935845799444 +0.4364 0.6285752673763315 0.628572338336739 -2.330859131122187e-07 -0.058042010255899515 +0.4365 0.6285952958617052 0.6285923706730049 -2.5020251729485077e-07 -0.05805208288958729 +0.43660000000000004 0.628615320013096 0.6286123990019603 -2.6728094366240684e-07 -0.058062153746867795 +0.43670000000000003 0.6286353398312824 0.6286324233236444 -2.8431807268941567e-07 -0.05807222282774627 +0.4368 0.628655355317073 0.6286524436380669 -3.0131079190032217e-07 -0.058082290132228 +0.4369 0.6286753664713061 0.6286724599452079 -3.18255996424599e-07 -0.058092355660318507 +0.437 0.6286953732948501 0.6286924722450181 -3.3515058965594147e-07 -0.05810241941202349 +0.43710000000000004 0.6287153757886031 0.6287124805374187 -3.5199148372411226e-07 -0.05811248138734879 +0.43720000000000003 0.6287353739534931 0.6287324848223016 -3.6877560007780863e-07 -0.05812254158630042 +0.4373 0.6287553677904772 0.6287524850995294 -3.854998700883461e-07 -0.05813260000888448 +0.4374 0.6287753573005426 0.6287724813689355 -4.0216123553538097e-07 -0.058142656655107344 +0.4375 0.6287953424847056 0.6287924736303244 -4.1875664925916656e-07 -0.0581527115249755 +0.43760000000000004 0.6288153233440117 0.6288124618834718 -4.352830756948478e-07 -0.058162764618495566 +0.43770000000000003 0.6288352998795357 0.6288324461281243 -4.5173749139981734e-07 -0.05817281593567434 +0.4378 0.6288552720923818 0.6288524263639996 -4.6811688554637687e-07 -0.05818286547651881 +0.4379 0.6288752399836827 0.6288724025907875 -4.844182607544045e-07 -0.05819291324103613 +0.438 0.6288952035546005 0.6288923748081483 -5.006386332301327e-07 -0.058202959229233554 +0.43810000000000004 0.6289151628063256 0.6289123430157153 -5.16775033682082e-07 -0.058213003441118585 +0.43820000000000003 0.6289351177400768 0.6289323072130922 -5.328245076263727e-07 -0.05822304587669878 +0.4383 0.6289550683571019 0.6289522673998557 -5.487841160389806e-07 -0.05823308653598194 +0.4384 0.6289750146586766 0.6289722235755539 -5.646509358692153e-07 -0.058243125418976 +0.4385 0.6289949566461046 0.6289921757397077 -5.804220605393207e-07 -0.05825316252568905 +0.43860000000000005 0.6290148943207179 0.6290121238918097 -5.960946005550971e-07 -0.05826319785612937 +0.43870000000000003 0.6290348276838764 0.6290320680313256 -6.116656840748913e-07 -0.05827323141030536 +0.4388 0.6290547567369674 0.6290520081576937 -6.271324572842962e-07 -0.058283263188225604 +0.4389 0.6290746814814054 0.6290719442703255 -6.424920851177962e-07 -0.05829329318989886 +0.439 0.6290946019186329 0.6290918763686046 -6.577417515224449e-07 -0.05830332141533399 +0.43910000000000005 0.629114518050119 0.6291118044518889 -6.728786602211434e-07 -0.05831334786454008 +0.43920000000000003 0.62913442987736 0.6291317285195093 -6.879000351428521e-07 -0.05832337253752639 +0.4393 0.6291543374018789 0.6291516485707702 -7.028031207834129e-07 -0.058333395434302285 +0.4394 0.6291742406252248 0.62917156460495 -7.175851830382163e-07 -0.05834341655487727 +0.4395 0.6291941395489734 0.6291914766213014 -7.322435094103685e-07 -0.058353435899261064 +0.43960000000000005 0.6292140341747272 0.6292113846190507 -7.467754096213142e-07 -0.058363453467463605 +0.43970000000000004 0.6292339245041138 0.6292312885973992 -7.611782162353364e-07 -0.05837346925949484 +0.4398 0.6292538105387865 0.6292511885555226 -7.754492849232353e-07 -0.058383483275364995 +0.4399 0.6292736922804245 0.6292710844925717 -7.895859952533613e-07 -0.058393495515084395 +0.44 0.6292935697307321 0.6292909764076723 -8.035857506083488e-07 -0.05840350597866359 +0.44010000000000005 0.6293134428914384 0.6293108642999256 -8.174459792953392e-07 -0.05841351466611322 +0.44020000000000004 0.6293333117642976 0.629330748168408 -8.311641347125143e-07 -0.05842352157744407 +0.4403 0.6293531763510882 0.6293506280121723 -8.447376960152297e-07 -0.058433526712667216 +0.4404 0.6293730366536133 0.6293705038302471 -8.581641681437713e-07 -0.05844353007179374 +0.4405 0.6293928926736998 0.6293903756216369 -8.714410828780661e-07 -0.05845353165483497 +0.44060000000000005 0.6294127444131984 0.6294102433853235 -8.845659987821719e-07 -0.05846353146180236 +0.44070000000000004 0.6294325918739834 0.6294301071202653 -8.975365020924553e-07 -0.05847352949270756 +0.4408 0.6294524350579526 0.6294499668253974 -9.103502067453473e-07 -0.058483525747562354 +0.4409 0.6294722739670263 0.629469822499633 -9.230047550712328e-07 -0.058493520226378694 +0.441 0.629492108603148 0.629489674141862 -9.35497818294051e-07 -0.058503512929168694 +0.44110000000000005 0.6295119389682835 0.629509521750953 -9.478270968366065e-07 -0.05851350385594461 +0.44120000000000004 0.6295317650644208 0.6295293653257521 -9.599903205981253e-07 -0.05852349300671883 +0.4413 0.6295515868935698 0.6295492048650845 -9.71985249842433e-07 -0.058533480381504015 +0.4414 0.6295714044577619 0.6295690403677537 -9.83809675086933e-07 -0.05854346598031285 +0.4415 0.6295912177590501 0.6295888718325425 -9.954614177409837e-07 -0.058553449803158276 +0.44160000000000005 0.6296110267995081 0.6296086992582126 -1.0069383304667223e-06 -0.05856343185005333 +0.44170000000000004 0.6296308315812306 0.6296285226435061 -1.0182382979284643e-06 -0.05857341212101124 +0.4418 0.6296506321063324 0.6296483419871444 -1.0293592366816817e-06 -0.05858339061604541 +0.4419 0.6296704283769492 0.6296681572878292 -1.0402990958391367e-06 -0.05859336733516938 +0.442 0.6296902203952357 0.629687968544243 -1.0510558572096595e-06 -0.058603342278396836 +0.44210000000000005 0.629710008163366 0.6297077757550491 -1.0616275361308158e-06 -0.058613315445741644 +0.44220000000000004 0.629729791683534 0.6297275789188916 -1.0720121812191064e-06 -0.05862328683721779 +0.4423 0.6297495709579524 0.629747378034397 -1.082207875285901e-06 -0.058633256452839524 +0.4424 0.6297693459888518 0.6297671731001725 -1.0922127355594835e-06 -0.0586432242926211 +0.4425 0.6297891167784817 0.6297869641148084 -1.1020249138515847e-06 -0.05865319035657707 +0.44260000000000005 0.6298088833291091 0.629806751076877 -1.1116425968904498e-06 -0.05866315464472208 +0.44270000000000004 0.6298286456430187 0.6298265339849337 -1.1210640069037048e-06 -0.05867311715707096 +0.4428 0.6298484037225122 0.6298463128375166 -1.1302874018681575e-06 -0.05868307789363863 +0.4429 0.6298681575699082 0.6298660876331479 -1.139311075759597e-06 -0.058693036854440245 +0.443 0.6298879071875422 0.6298858583703332 -1.148133358885861e-06 -0.05870299403949111 +0.44310000000000005 0.6299076525777654 0.6299056250475624 -1.1567526183586807e-06 -0.05871294944880665 +0.44320000000000004 0.6299273937429448 0.6299253876633101 -1.165167258232458e-06 -0.058722903082402494 +0.4433 0.6299471306854634 0.6299451462160356 -1.1733757196152883e-06 -0.05873285494029437 +0.4434 0.6299668634077185 0.6299649007041839 -1.1813764813906058e-06 -0.05874280502249823 +0.4435 0.6299865919121226 0.6299846511261848 -1.189168060272694e-06 -0.05875275332903014 +0.44360000000000005 0.6300063162011028 0.6300043974804549 -1.1967490112230195e-06 -0.058762699859906356 +0.44370000000000004 0.6300260362770999 0.6300241397653968 -1.2041179273947211e-06 -0.058772644615143255 +0.44380000000000003 0.6300457521425683 0.6300438779793996 -1.2112734407432324e-06 -0.05878258759475741 +0.4439 0.6300654637999756 0.6300636121208399 -1.2182142221373038e-06 -0.05879252879876549 +0.444 0.6300851712518027 0.6300833421880816 -1.2249389816920697e-06 -0.05880246822718439 +0.44410000000000005 0.6301048745005429 0.6301030681794761 -1.2314464689078264e-06 -0.058812405880031164 +0.44420000000000004 0.6301245735487013 0.6301227900933635 -1.2377354730586099e-06 -0.058822341757322955 +0.44430000000000003 0.6301442683987954 0.6301425079280722 -1.243804823330974e-06 -0.05883227585907717 +0.4444 0.6301639590533533 0.6301622216819197 -1.2496533886852124e-06 -0.058842208185311246 +0.4445 0.6301836455149148 0.6301819313532129 -1.2552800788823149e-06 -0.05885213873604287 +0.4446 0.6302033277860298 0.6302016369402482 -1.2606838440121226e-06 -0.058862067511289855 +0.44470000000000004 0.6302230058692588 0.6302213384413125 -1.265863674965173e-06 -0.05887199451107017 +0.44480000000000003 0.6302426797671721 0.6302410358546826 -1.2708186037102553e-06 -0.05888191973540196 +0.4449 0.6302623494823492 0.6302607291786269 -1.2755477029613438e-06 -0.058891843184303516 +0.445 0.6302820150173787 0.6302804184114045 -1.2800500870935316e-06 -0.05890176485779324 +0.4451 0.6303016763748579 0.6303001035512668 -1.284324911948742e-06 -0.05891168475588979 +0.44520000000000004 0.6303213335573927 0.630319784596457 -1.2883713749745063e-06 -0.0589216028786119 +0.44530000000000003 0.6303409865675964 0.6303394615452108 -1.2921887153349854e-06 -0.058931519225978495 +0.4454 0.6303606354080897 0.6303591343957566 -1.2957762140497486e-06 -0.058941433798008626 +0.4455 0.630380280081501 0.6303788031463164 -1.2991331945488849e-06 -0.05895134659472156 +0.4456 0.6303999205904647 0.630398467795106 -1.3022590223399355e-06 -0.058961257616136666 +0.44570000000000004 0.6304195569376214 0.630418128340335 -1.305153105174428e-06 -0.05897116686227352 +0.44580000000000003 0.6304391891256185 0.6304377847802076 -1.3078148934364542e-06 -0.058981074333151785 +0.4459 0.6304588171571075 0.6304574371129228 -1.3102438800038918e-06 -0.058990980028791364 +0.446 0.6304784410347459 0.6304770853366751 -1.3124396004426941e-06 -0.05900088394921223 +0.4461 0.6304980607611954 0.6304967294496546 -1.3144016332011788e-06 -0.059010786094434546 +0.44620000000000004 0.630517676339122 0.6305163694500479 -1.3161295993324718e-06 -0.05902068646447867 +0.44630000000000003 0.6305372877711952 0.6305360053360377 -1.3176231629663526e-06 -0.059030585059365065 +0.4464 0.6305568950600886 0.6305556371058041 -1.3188820313647653e-06 -0.05904048187911437 +0.4465 0.6305764982084785 0.630575264757524 -1.319905954755285e-06 -0.059050376923747476 +0.4466 0.6305960972190432 0.6305948882893728 -1.3206947265254065e-06 -0.05906027019328524 +0.44670000000000004 0.6306156920944637 0.6306145076995235 -1.321248183111523e-06 -0.059070161687748826 +0.44680000000000003 0.6306352828374228 0.6306341229861483 -1.3215662042764809e-06 -0.059080051407159474 +0.4469 0.630654869450604 0.6306537341474177 -1.32164871310958e-06 -0.05908993935153859 +0.447 0.6306744519366922 0.6306733411815018 -1.3214956758322849e-06 -0.059099825520907735 +0.4471 0.6306940302983725 0.6306929440865716 -1.3211071019092469e-06 -0.0591097099152887 +0.44720000000000004 0.6307136045383306 0.630712542860797 -1.3204830442703486e-06 -0.059119592534703336 +0.44730000000000003 0.6307331746592514 0.6307321375023496 -1.3196235991164151e-06 -0.059129473379173736 +0.4474 0.6307527406638191 0.6307517280094013 -1.318528905530636e-06 -0.059139352448722086 +0.4475 0.6307723025547173 0.6307713143801263 -1.3171991463667432e-06 -0.05914922974337078 +0.4476 0.6307918603346268 0.6307908966127004 -1.3156345476106335e-06 -0.05915910526314229 +0.44770000000000004 0.6308114140062271 0.6308104747053013 -1.3138353783526124e-06 -0.059168979008059265 +0.44780000000000003 0.6308309635721956 0.6308300486561099 -1.3118019507041279e-06 -0.05917885097814457 +0.4479 0.6308505090352065 0.6308496184633106 -1.3095346201308367e-06 -0.05918872117342116 +0.448 0.6308700503979306 0.6308691841250909 -1.3070337852028047e-06 -0.05919858959391222 +0.4481 0.6308895876630354 0.6308887456396426 -1.304299887178173e-06 -0.05920845623964101 +0.44820000000000004 0.6309091208331841 0.6309083030051617 -1.3013334104194918e-06 -0.059218321110630995 +0.44830000000000003 0.6309286499110353 0.6309278562198489 -1.298134882199431e-06 -0.059228184206905746 +0.4484 0.6309481748992428 0.6309474052819108 -1.294704872534247e-06 -0.05923804552848905 +0.4485 0.6309676958004554 0.6309669501895592 -1.2910439938784712e-06 -0.05924790507540483 +0.4486 0.6309872126173159 0.6309864909410116 -1.2871529014024663e-06 -0.059257762847677135 +0.44870000000000004 0.631006725352461 0.6310060275344926 -1.2830322929369142e-06 -0.05926761884533021 +0.44880000000000003 0.6310262340085208 0.6310255599682335 -1.278682908112394e-06 -0.05927747306838841 +0.4489 0.6310457385881185 0.6310450882404729 -1.2741055291920489e-06 -0.0592873255168763 +0.449 0.6310652390938702 0.6310646123494568 -1.269300980349941e-06 -0.05929717619081857 +0.4491 0.631084735528384 0.6310841322934397 -1.2642701277265633e-06 -0.059307025090240065 +0.44920000000000004 0.6311042278942596 0.6311036480706841 -1.2590138789569938e-06 -0.05931687221516573 +0.44930000000000003 0.6311237161940888 0.631123159679462 -1.2535331836149854e-06 -0.05932671756562078 +0.4494 0.6311432004304539 0.6311426671180544 -1.24782903268561e-06 -0.05933656114163052 +0.4495 0.6311626806059281 0.631162170384752 -1.2419024580379023e-06 -0.059346402943220355 +0.4496 0.6311821567230748 0.6311816694778555 -1.2357545332020159e-06 -0.059356242970416 +0.44970000000000004 0.6312016287844471 0.6312011643956761 -1.2293863723422671e-06 -0.05936608122324313 +0.44980000000000003 0.6312210967925878 0.631220655136536 -1.2227991300906016e-06 -0.05937591770172771 +0.4499 0.6312405607500287 0.6312401416987687 -1.2159940017408832e-06 -0.05938575240589583 +0.45 0.6312600206592903 0.6312596240807193 -1.208972222999094e-06 -0.05939558533577374 +0.4501 0.6312794765228813 0.6312791022807451 -1.2017350694837337e-06 -0.05940541649138782 +0.45020000000000004 0.6312989283432986 0.6312985762972154 -1.1942838566425529e-06 -0.059415245872764616 +0.45030000000000003 0.6313183761230263 0.6313180461285125 -1.1866199396415311e-06 -0.059425073479930805 +0.4504 0.6313378198645356 0.6313375117730321 -1.178744712809765e-06 -0.059434899312913264 +0.4505 0.631357259570285 0.6313569732291834 -1.1706596097782462e-06 -0.059444723371738985 +0.4506 0.6313766952427188 0.6313764304953895 -1.1623661028414833e-06 -0.05945454565643518 +0.45070000000000005 0.6313961268842676 0.6313958835700876 -1.1538657029297461e-06 -0.05946436616702908 +0.45080000000000003 0.6314155544973474 0.63141533245173 -1.1451599594980433e-06 -0.05947418490354825 +0.4509 0.63143497808436 0.6314347771387838 -1.1362504598877443e-06 -0.05948400186602021 +0.451 0.6314543976476916 0.6314542176297313 -1.1271388290490236e-06 -0.05949381705447279 +0.4511 0.6314738131897133 0.6314736539230711 -1.1178267296241273e-06 -0.05950363046893388 +0.45120000000000005 0.6314932247127802 0.6314930860173177 -1.1083158612534838e-06 -0.05951344210943165 +0.45130000000000003 0.6315126322192315 0.631512513911002 -1.0986079605201926e-06 -0.059523251975994264 +0.4514 0.6315320357113894 0.6315319376026721 -1.0887048005614464e-06 -0.05953306006865014 +0.4515 0.6315514351915597 0.6315513570908928 -1.078608190596686e-06 -0.05954286638742783 +0.4516 0.6315708306620307 0.631570772374247 -1.0683199758720896e-06 -0.059552670932356014 +0.45170000000000005 0.6315902221250733 0.6315901834513349 -1.0578420372719943e-06 -0.05956247370346355 +0.45180000000000003 0.6316096095829403 0.6316095903207753 -1.0471762905972515e-06 -0.059572274700779415 +0.4519 0.6316289930378666 0.631628992981206 -1.036324686926049e-06 -0.059582073924332825 +0.452 0.6316483724920681 0.6316483914312828 -1.0252892116147105e-06 -0.05959187137415304 +0.4521 0.631667747947742 0.6316677856696814 -1.0140718841311624e-06 -0.05960166705026957 +0.45220000000000005 0.6316871194070666 0.631687175695097 -1.002674758082689e-06 -0.059611460952712 +0.45230000000000004 0.6317064868722 0.6317065615062445 -9.910999199946868e-07 -0.059621253081510096 +0.4524 0.6317258503452807 0.6317259431018589 -9.793494898380217e-07 -0.05963104343669379 +0.4525 0.6317452098284272 0.6317453204806963 -9.674256201408493e-07 -0.05964083201829315 +0.4526 0.631764565323737 0.6317646936415332 -9.55330495627793e-07 -0.059650618826338424 +0.45270000000000005 0.631783916833287 0.6317840625831675 -9.430663329423883e-07 -0.05966040386085996 +0.45280000000000004 0.6318032643591334 0.6318034273044183 -9.30635380147482e-07 -0.0596701871218883 +0.4529 0.6318226079033106 0.6318227878041268 -9.18039916586455e-07 -0.05967996860945418 +0.453 0.6318419474678308 0.631842144081156 -9.052822519672876e-07 -0.059689748323588414 +0.4531 0.631861283054685 0.6318614961343915 -8.923647264458268e-07 -0.059699526264321984 +0.45320000000000005 0.6318806146658413 0.6318808439627412 -8.792897097931185e-07 -0.059709302431685984 +0.45330000000000004 0.6318999423032456 0.6319001875651364 -8.660596012843857e-07 -0.05971907682571181 +0.4534 0.6319192659688203 0.6319195269405316 -8.52676829199428e-07 -0.05972884944643084 +0.4535 0.6319385856644654 0.6319388620879043 -8.391438500454651e-07 -0.059738620293874695 +0.4536 0.6319579013920568 0.6319581930062561 -8.254631486126485e-07 -0.05974838936807512 +0.45370000000000005 0.6319772131534469 0.6319775196946129 -8.116372372246605e-07 -0.05975815666906403 +0.45380000000000004 0.6319965209504643 0.6319968421520246 -7.976686552668699e-07 -0.059767922196873484 +0.4539 0.6320158247849132 0.6320161603775656 -7.835599688532646e-07 -0.05977768595153567 +0.454 0.6320351246585735 0.6320354743703355 -7.693137702713404e-07 -0.059787447933082986 +0.4541 0.6320544205731999 0.6320547841294586 -7.549326775657672e-07 -0.0597972081415479 +0.45420000000000005 0.6320737125305226 0.6320740896540848 -7.404193339555221e-07 -0.05980696657696314 +0.45430000000000004 0.6320930005322459 0.6320933909433898 -7.257764075840889e-07 -0.05981672323936147 +0.4544 0.6321122845800495 0.6321126879965745 -7.110065906312801e-07 -0.05982647812877589 +0.4545 0.6321315646755867 0.6321319808128663 -6.961125992854811e-07 -0.05983623124523951 +0.4546 0.632150840820485 0.6321512693915186 -6.810971728554716e-07 -0.059845982588785575 +0.45470000000000005 0.6321701130163458 0.6321705537318114 -6.659630735483812e-07 -0.05985573215944753 +0.45480000000000004 0.6321893812647443 0.6321898338330515 -6.507130857758003e-07 -0.05986547995725893 +0.4549 0.6322086455672288 0.6322091096945728 -6.35350015792957e-07 -0.05987522598225353 +0.455 0.6322279059253209 0.6322283813157359 -6.198766910325837e-07 -0.05988497023446522 +0.4551 0.6322471623405153 0.6322476486959293 -6.042959596885833e-07 -0.059894712713928 +0.45520000000000005 0.6322664148142791 0.6322669118345685 -5.886106901609178e-07 -0.05990445342067603 +0.45530000000000004 0.6322856633480521 0.632286170731097 -5.728237705698858e-07 -0.059914192354743684 +0.4554 0.6323049079432472 0.6323054253849865 -5.569381081177438e-07 -0.05992392951616543 +0.4555 0.6323241486012484 0.6323246757957365 -5.409566287833956e-07 -0.059933664904975904 +0.4556 0.6323433853234124 0.6323439219628745 -5.248822764342131e-07 -0.05994339852120985 +0.45570000000000005 0.6323626181110679 0.6323631638859573 -5.087180126317481e-07 -0.05995313036490229 +0.45580000000000004 0.6323818469655147 0.6323824015645697 -4.924668158129419e-07 -0.05996286043608823 +0.4559 0.6324010718880244 0.6324016349983255 -4.761316810125704e-07 -0.05997258873480293 +0.456 0.6324202928798404 0.6324208641868673 -4.597156190583318e-07 -0.059982315261081776 +0.4561 0.6324395099421765 0.6324400891298672 -4.432216562100244e-07 -0.05999204001496035 +0.45620000000000005 0.6324587230762182 0.6324593098270264 -4.266528334379016e-07 -0.0600017629964743 +0.45630000000000004 0.6324779322831215 0.6324785262780751 -4.100122059508271e-07 -0.060011484205659466 +0.45640000000000003 0.6324971375640136 0.6324977384827737 -3.933028426966745e-07 -0.06002120364255184 +0.4565 0.6325163389199919 0.6325169464409119 -3.765278256753768e-07 -0.06003092130718756 +0.4566 0.6325355363521243 0.6325361501523094 -3.5969024945320394e-07 -0.060040637199602925 +0.45670000000000005 0.6325547298614498 0.6325553496168155 -3.4279322051050665e-07 -0.06005035131983434 +0.4568 0.632573919448977 0.6325745448343099 -3.258398567976273e-07 -0.060060063667918474 +0.45690000000000003 0.6325931051156851 0.6325937358047022 -3.088332870548882e-07 -0.06006977424389201 +0.457 0.6326122868625229 0.6326129225279329 -2.9177665025054145e-07 -0.06007948304779187 +0.4571 0.6326314646904097 0.6326321050039715 -2.7467309502565707e-07 -0.06008919007965507 +0.45720000000000005 0.6326506386002341 0.632651283232819 -2.5752577913901176e-07 -0.0600988953395188 +0.4573 0.632669808592855 0.6326704572145072 -2.403378687731994e-07 -0.06010859882742045 +0.45740000000000003 0.6326889746691008 0.6326896269490974 -2.2311253810441967e-07 -0.060118300543397424 +0.4575 0.6327081368297696 0.6327087924366828 -2.0585296862246638e-07 -0.06012800048748743 +0.4576 0.632727295075629 0.6327279536773862 -1.8856234851663545e-07 -0.06013769865972828 +0.45770000000000005 0.632746449407416 0.6327471106713624 -1.7124387221081894e-07 -0.06014739506015785 +0.4578 0.6327655998258369 0.632766263418796 -1.5390073963492124e-07 -0.06015708968881427 +0.45790000000000003 0.6327847463315681 0.6327854119199037 -1.365361556975031e-07 -0.06016678254573579 +0.458 0.6328038889252543 0.6328045561749319 -1.1915332972026182e-07 -0.060176473630960736 +0.4581 0.6328230276075105 0.632823696184159 -1.0175547477189739e-07 -0.06018616294452772 +0.45820000000000005 0.6328421623789204 0.6328428319478943 -8.434580714943019e-08 -0.06019585048647541 +0.4583 0.6328612932400366 0.6328619634664778 -6.692754573461857e-08 -0.06020553625684264 +0.45840000000000003 0.6328804201913818 0.6328810907402809 -4.950391141109178e-08 -0.06021522025566837 +0.4585 0.632899543233447 0.6329002137697064 -3.207812647606188e-08 -0.060224902482991796 +0.4586 0.6329186623666931 0.6329193325551881 -1.4653414035555729e-08 -0.06023458293885217 +0.45870000000000005 0.6329377775915493 0.6329384470971905 2.7670025888604233e-09 -0.060244261623288914 +0.4588 0.6329568889084147 0.6329575573962101 2.0179900460728928e-08 -0.06025393853634164 +0.45890000000000003 0.6329759963176573 0.6329766634527737 3.7582057618723574e-08 -0.06026361367805007 +0.459 0.6329950998196141 0.6329957652674401 5.497025368401964e-08 -0.06027328704845406 +0.4591 0.6330141994145915 0.6330148628407988 7.23412704566051e-08 -0.06028295864759371 +0.45920000000000005 0.6330332951028652 0.6330339561734701 8.969189247906573e-08 -0.06029262847550915 +0.4593 0.6330523868846794 0.6330530452661061 1.0701890769404532e-07 -0.06030229653224069 +0.45940000000000003 0.6330714747602483 0.6330721301193896 1.2431910799068357e-07 -0.06031196281782883 +0.4595 0.6330905587297553 0.6330912107340343 1.4158928979615681e-07 -0.0603216273323142 +0.4596 0.6331096387933528 0.6331102871107853 1.5882625472446454e-07 -0.060331290075737565 +0.45970000000000005 0.6331287149511631 0.6331293592504184 1.7602681012807153e-07 -0.06034095104813986 +0.4598 0.6331477872032776 0.6331484271537401 1.9318776967036655e-07 -0.06035061024956219 +0.45990000000000003 0.6331668555497568 0.6331674908215881 2.1030595396404062e-07 -0.06036026768004571 +0.46 0.6331859199906317 0.6331865502548304 2.2737819115048463e-07 -0.06036992333963181 +0.4601 0.6332049805259022 0.6332056054543662 2.444013174549009e-07 -0.060379577228362014 +0.46020000000000005 0.633224037155538 0.6332246564211247 2.6137217783162026e-07 -0.06038922934627795 +0.4603 0.6332430898794786 0.6332437031560665 2.782876264983969e-07 -0.06039887969342148 +0.46040000000000003 0.6332621386976338 0.6332627456601818 2.951445275747866e-07 -0.06040852826983454 +0.4605 0.6332811836098833 0.6332817839344915 3.1193975556093045e-07 -0.06041817507555927 +0.4606 0.6333002246160764 0.6333008179800468 3.286701960314442e-07 -0.06042782011063791 +0.46070000000000005 0.6333192617160327 0.6333198477979287 3.4533274623216315e-07 -0.06043746337511285 +0.4608 0.6333382949095427 0.6333388733892487 3.6192431548953685e-07 -0.06044710486902665 +0.46090000000000003 0.6333573241963667 0.6333578947551476 3.7844182591839637e-07 -0.06045674459242201 +0.461 0.6333763495762355 0.6333769118967968 3.948822130950269e-07 -0.060466382545341806 +0.4611 0.6333953710488509 0.6333959248153964 4.112424263902348e-07 -0.06047601872782896 +0.46120000000000005 0.6334143886138855 0.633414933512177 4.275194296077256e-07 -0.06048565313992671 +0.4613 0.6334334022709827 0.6334339379883975 4.4371020171962705e-07 -0.06049528578167828 +0.46140000000000003 0.6334524120197567 0.6334529382453472 4.598117372273114e-07 -0.06050491665312712 +0.4615 0.6334714178597934 0.6334719342843437 4.758210468552848e-07 -0.06051454575431686 +0.4616 0.6334904197906501 0.6334909261067335 4.9173515803691e-07 -0.06052417308529118 +0.46170000000000005 0.6335094178118553 0.6335099137138924 5.075511154001289e-07 -0.06053379864609398 +0.4618 0.6335284119229093 0.6335288971072244 5.232659815584961e-07 -0.06054342243676928 +0.46190000000000003 0.6335474021232843 0.633547876288162 5.388768373609798e-07 -0.060553044457361274 +0.462 0.633566388412425 0.6335668512581661 5.543807827246283e-07 -0.060562664707914264 +0.4621 0.6335853707897473 0.6335858220187256 5.697749367872262e-07 -0.060572283188472714 +0.46220000000000006 0.6336043492546408 0.6336047885713572 5.850564389620061e-07 -0.06058189989908128 +0.4623 0.6336233238064667 0.6336237509176053 6.00222449159693e-07 -0.06059151483978468 +0.46240000000000003 0.6336422944445594 0.6336427090590419 6.15270148163205e-07 -0.060601128010627836 +0.4625 0.6336612611682269 0.6336616629972662 6.301967385574647e-07 -0.06061073941165584 +0.4626 0.6336802239767492 0.6336806127339046 6.44999444951444e-07 -0.06062034904291383 +0.46270000000000006 0.6336991828693809 0.6336995582706102 6.596755146442979e-07 -0.06062995690444722 +0.4628 0.6337181378453495 0.6337184996090631 6.742222180555757e-07 -0.060639562996301466 +0.46290000000000003 0.6337370889038565 0.6337374367509695 6.886368492664552e-07 -0.060649167318522226 +0.463 0.633756036044078 0.6337563696980615 7.029167266303649e-07 -0.060658769871155274 +0.4631 0.6337749792651641 0.633775298452098 7.170591930227843e-07 -0.06066837065424657 +0.46320000000000006 0.6337939185662395 0.6337942230148632 7.310616164379891e-07 -0.06067796966784222 +0.4633 0.6338128539464034 0.6338131433881665 7.449213908494734e-07 -0.06068756691198839 +0.46340000000000003 0.6338317854047307 0.6338320595738431 7.58635936043417e-07 -0.06069716238673151 +0.4635 0.6338507129402711 0.6338509715737528 7.722026986733965e-07 -0.06070675609211806 +0.4636 0.6338696365520502 0.6338698793897803 7.856191524546752e-07 -0.06071634802819473 +0.46370000000000006 0.633888556239069 0.6338887830238347 7.988827986638025e-07 -0.060725938195008315 +0.4638 0.6339074720003054 0.6339076824778493 8.11991166582704e-07 -0.06073552659260581 +0.46390000000000003 0.633926383834713 0.6339265777537816 8.249418140537923e-07 -0.06074511322103429 +0.464 0.633945291741222 0.6339454688536121 8.377323280073234e-07 -0.06075469808034101 +0.4641 0.6339641957187402 0.6339643557793455 8.503603247389524e-07 -0.060764281170573364 +0.46420000000000006 0.6339830957661519 0.6339832385330092 8.628234504926002e-07 -0.06077386249177892 +0.4643 0.6340019918823192 0.6340021171166532 8.751193817102543e-07 -0.060783442044005355 +0.46440000000000003 0.6340208840660819 0.6340209915323507 8.872458256703464e-07 -0.06079301982730049 +0.4645 0.6340397723162581 0.6340398617821961 8.992005208208198e-07 -0.060802595841712305 +0.4646 0.634058656631644 0.634058727868307 9.109812373342407e-07 -0.060812170087288966 +0.46470000000000006 0.6340775370110145 0.6340775897928215 9.225857772743318e-07 -0.06082174256407872 +0.4648 0.6340964134531237 0.6340964475578994 9.340119752898612e-07 -0.06083131327212994 +0.46490000000000004 0.6341152859567053 0.6341153011657217 9.452576988644434e-07 -0.06084088221149125 +0.465 0.6341341545204722 0.6341341506184897 9.5632084862185e-07 -0.06085044938221134 +0.4651 0.6341530191431171 0.6341529959184256 9.671993591031658e-07 -0.06086001478433907 +0.46520000000000006 0.6341718798233131 0.6341718370677709 9.778911987390337e-07 -0.06086957841792341 +0.4653 0.6341907365597141 0.6341906740687877 9.88394370404766e-07 -0.06087914028301353 +0.46540000000000004 0.634209589350955 0.6342095069237565 9.98706911808922e-07 -0.06088870037965868 +0.4655 0.6342284381956514 0.6342283356349779 1.0088268959096425e-06 -0.060898258707908354 +0.4656 0.6342472830924013 0.6342471602047702 1.0187524310811824e-06 -0.06090781526781208 +0.46570000000000006 0.634266124039784 0.6342659806354705 1.0284816617800452e-06 -0.0609173700594196 +0.4658 0.6342849610363613 0.6342847969294341 1.0380127684894713e-06 -0.060926923082780776 +0.46590000000000004 0.634303794080678 0.6343036090890336 1.0473439685243502e-06 -0.06093647433794561 +0.466 0.6343226231712614 0.634322417116659 1.0564735160589755e-06 -0.06094602382496428 +0.4661 0.6343414483066223 0.6343412210147175 1.065399702626646e-06 -0.06095557154388707 +0.46620000000000006 0.6343602694852553 0.6343600207856326 1.074120857175176e-06 -0.06096511749476441 +0.4663 0.6343790867056389 0.6343788164318441 1.0826353467330296e-06 -0.06097466167764692 +0.46640000000000004 0.6343978999662365 0.6343976079558078 1.0909415764648323e-06 -0.06098420409258533 +0.4665 0.6344167092654958 0.6344163953599948 1.0990379900877034e-06 -0.0609937447396305 +0.4666 0.6344355146018499 0.6344351786468918 1.1069230703153465e-06 -0.061003283618833504 +0.46670000000000006 0.6344543159737176 0.6344539578189993 1.1145953387192709e-06 -0.06101282073024547 +0.4668 0.6344731133795032 0.634472732878833 1.1220533563394142e-06 -0.061022356073917684 +0.46690000000000004 0.6344919068175977 0.6344915038289225 1.1292957240727208e-06 -0.06103188964990167 +0.467 0.6345106962863787 0.6345102706718104 1.1363210824510972e-06 -0.06104142145824898 +0.4671 0.6345294817842106 0.6345290334100533 1.1431281124740789e-06 -0.061050951499011345 +0.46720000000000006 0.6345482633094458 0.6345477920462204 1.149715535581075e-06 -0.06106047977224072 +0.4673 0.6345670408604243 0.6345665465828929 1.1560821136791244e-06 -0.061070006277989065 +0.46740000000000004 0.6345858144354741 0.6345852970226646 1.1622266499478062e-06 -0.06107953101630862 +0.4675 0.6346045840329124 0.6346040433681408 1.1681479884229073e-06 -0.061089053987251646 +0.4676 0.6346233496510449 0.6346227856219377 1.1738450148013335e-06 -0.061098575190870634 +0.46770000000000006 0.6346421112881672 0.6346415237866831 1.1793166560525314e-06 -0.061108094627218196 +0.4678 0.6346608689425641 0.6346602578650147 1.1845618812789116e-06 -0.061117612296347074 +0.46790000000000004 0.6346796226125113 0.6346789878595803 1.1895797013550258e-06 -0.06112712819831019 +0.468 0.6346983722962749 0.6346977137730374 1.1943691695937009e-06 -0.06113664233316052 +0.4681 0.6347171179921122 0.634716435608053 1.1989293815517499e-06 -0.061146154700951305 +0.46820000000000006 0.6347358596982715 0.6347351533673025 1.20325947541855e-06 -0.06115566530173586 +0.4683 0.6347545974129938 0.63475386705347 1.2073586319605312e-06 -0.061165174135567615 +0.46840000000000004 0.6347733311345112 0.6347725766692475 1.2112260750485326e-06 -0.061174681202500206 +0.4685 0.6347920608610496 0.6347912822173347 1.2148610714912689e-06 -0.06118418650258737 +0.4686 0.6348107865908278 0.6348099837004384 1.2182629311463522e-06 -0.061193690035883035 +0.46870000000000006 0.6348295083220579 0.6348286811212721 1.2214310074476487e-06 -0.061203191802441215 +0.4688 0.634848226052946 0.634847374482556 1.2243646971832334e-06 -0.06121269180231612 +0.46890000000000004 0.6348669397816924 0.6348660637870157 1.2270634407451908e-06 -0.06122219003556206 +0.469 0.6348856495064924 0.6348847490373826 1.2295267220185924e-06 -0.061231686502233464 +0.4691 0.6349043552255367 0.6349034302363933 1.2317540688533413e-06 -0.06124118120238499 +0.46920000000000006 0.6349230569370115 0.6349221073867888 1.2337450530086613e-06 -0.06125067413607143 +0.4693 0.6349417546390987 0.6349407804913144 1.2354992901808526e-06 -0.061260165303347616 +0.46940000000000004 0.6349604483299774 0.6349594495527193 1.2370164400310468e-06 -0.061269654704268595 +0.4695 0.634979138007823 0.6349781145737559 1.2382962064350078e-06 -0.06127914233888955 +0.4696 0.6349978236708085 0.6349967755571798 1.2393383373165978e-06 -0.06128862820726583 +0.46970000000000006 0.6350165053171046 0.6350154325057493 1.2401426251196224e-06 -0.061298112309452917 +0.4698 0.6350351829448799 0.6350340854222241 1.2407089062804744e-06 -0.061307594645506336 +0.46990000000000004 0.6350538565523025 0.6350527343093664 1.2410370616722233e-06 -0.061317075215481964 +0.47 0.6350725261375385 0.635071379169939 1.2411270164935928e-06 -0.06132655401943558 +0.4701 0.6350911916987542 0.6350900200067058 1.2409787403799832e-06 -0.06133603105742326 +0.47020000000000006 0.6351098532341154 0.6351086568224312 1.2405922473479603e-06 -0.06134550632950119 +0.4703 0.6351285107417884 0.6351272896198796 1.239967595795255e-06 -0.06135497983572569 +0.47040000000000004 0.6351471642199404 0.6351459184018143 1.2391048884452527e-06 -0.061364451576153216 +0.4705 0.6351658136667395 0.6351645431709987 1.2380042724580154e-06 -0.06137392155084037 +0.4706 0.6351844590803555 0.6351831639301939 1.2366659393747703e-06 -0.0613833897598439 +0.47070000000000006 0.6352031004589604 0.6352017806821604 1.2350901249513768e-06 -0.06139285620322073 +0.4708 0.6352217378007288 0.6352203934296554 1.2332771094358819e-06 -0.061402320881027886 +0.47090000000000004 0.6352403711038375 0.6352390021754339 1.231227217179942e-06 -0.06141178379332246 +0.471 0.6352590003664672 0.635257606922248 1.2289408168053573e-06 -0.06142124494016182 +0.4711 0.6352776255868023 0.6352762076728461 1.2264183207877366e-06 -0.061430704321603406 +0.47120000000000006 0.6352962467630316 0.635294804429973 1.223660186233655e-06 -0.06144016193770483 +0.4713 0.6353148638933479 0.6353133971963689 1.2206669136871628e-06 -0.06144961778852381 +0.47140000000000004 0.6353334769759497 0.6353319859747697 1.2174390478791874e-06 -0.06145907187411825 +0.4715 0.6353520860090403 0.6353505707679057 1.2139771773667096e-06 -0.06146852419454614 +0.4716 0.6353706909908294 0.6353691515785017 1.2102819342552085e-06 -0.061477974749865674 +0.47170000000000006 0.6353892919195328 0.6353877284092765 1.206353994337439e-06 -0.06148742354013514 +0.4718 0.6354078887933732 0.6354063012629427 1.202194076926899e-06 -0.061496870565413 +0.47190000000000004 0.6354264816105801 0.6354248701422056 1.1978029446080285e-06 -0.0615063158257578 +0.472 0.6354450703693907 0.6354434350497636 1.1931814032362098e-06 -0.06151575932122827 +0.4721 0.6354636550680504 0.6354619959883075 1.1883303016879676e-06 -0.061525201051883305 +0.47220000000000006 0.6354822357048127 0.6354805529605195 1.1832505318332132e-06 -0.06153464101778188 +0.4723 0.63550081227794 0.6354991059690737 1.1779430282021774e-06 -0.061544079218983166 +0.47240000000000004 0.6355193847857044 0.6355176550166353 1.1724087680409223e-06 -0.06155351565554649 +0.4725 0.6355379532263867 0.6355362001058598 1.1666487708394957e-06 -0.0615629503275312 +0.4726 0.6355565175982782 0.6355547412393932 1.160664098442954e-06 -0.06157238323499689 +0.47270000000000006 0.635575077899681 0.6355732784198715 1.1544558548015615e-06 -0.0615818143780033 +0.4728 0.6355936341289076 0.6355918116499195 1.1480251856099688e-06 -0.06159124375661025 +0.47290000000000004 0.635612186284282 0.6356103409321521 1.1413732782794561e-06 -0.06160067137087777 +0.473 0.6356307343641399 0.6356288662691715 1.134501361549356e-06 -0.06161009722086598 +0.4731 0.6356492783668286 0.6356473876635692 1.1274107053482751e-06 -0.06161952130663513 +0.47320000000000007 0.6356678182907087 0.635665905117924 1.1201026208496057e-06 -0.06162894362824568 +0.4733 0.6356863541341529 0.6356844186348021 1.1125784596666133e-06 -0.06163836418575811 +0.47340000000000004 0.6357048858955473 0.6357029282167572 1.1048396139634598e-06 -0.06164778297923316 +0.4735 0.6357234135732919 0.6357214338663291 1.0968875161221359e-06 -0.06165720000873164 +0.4736 0.6357419371658006 0.6357399355860442 1.0887236386591947e-06 -0.061666615274314565 +0.47370000000000007 0.635760456671502 0.6357584333784146 1.0803494935873736e-06 -0.061676028776043015 +0.4738 0.635778972088839 0.6357769272459382 1.0717666324988606e-06 -0.061685440513978264 +0.47390000000000004 0.63579748341627 0.6357954171910974 1.0629766460379386e-06 -0.0616948504881817 +0.474 0.6358159906522687 0.6358139032163598 1.0539811638454744e-06 -0.06170425869871482 +0.4741 0.6358344937953251 0.6358323853241771 1.04478185392054e-06 -0.06171366514563931 +0.47420000000000007 0.6358529928439455 0.635850863516985 1.0353804227314356e-06 -0.06172306982901701 +0.4743 0.6358714877966527 0.6358693377972032 1.025778614549555e-06 -0.06173247274890989 +0.47440000000000004 0.6358899786519862 0.6358878081672341 1.0159782112273419e-06 -0.06174187390537997 +0.4745 0.6359084654085038 0.6359062746294635 1.0059810319762441e-06 -0.06175127329848954 +0.4746 0.6359269480647802 0.635924737186259 9.95788932950381e-07 -0.061760670928300954 +0.47470000000000007 0.6359454266194089 0.6359431958399712 9.854038070522542e-07 -0.06177006679487673 +0.4748 0.6359639010710013 0.6359616505929315 9.748275832666131e-07 -0.06177946089827947 +0.47490000000000004 0.6359823714181881 0.635980101447454 9.64062226660456e-07 -0.06178885323857201 +0.475 0.6360008376596189 0.6359985484058325 9.531097377168951e-07 -0.06179824381581725 +0.4751 0.6360192997939631 0.6360169914703427 9.419721521963798e-07 -0.06180763263007826 +0.47520000000000007 0.6360377578199096 0.6360354306432403 9.306515405538285e-07 -0.06181701968141824 +0.4753 0.6360562117361679 0.6360538659267612 9.191500078831183e-07 -0.06182640496990058 +0.47540000000000004 0.6360746615414677 0.6360722973231208 9.074696930844173e-07 -0.06183578849558873 +0.4755 0.6360931072345598 0.6360907248345138 8.956127688919402e-07 -0.0618451702585463 +0.4756 0.6361115488142164 0.6361091484631146 8.835814412910814e-07 -0.061854550258837085 +0.47570000000000007 0.6361299862792302 0.6361275682110757 8.713779488800366e-07 -0.06186392849652494 +0.4758 0.6361484196284173 0.6361459840805287 8.590045630363363e-07 -0.06187330497167394 +0.47590000000000005 0.6361668488606144 0.6361643960735825 8.464635868343784e-07 -0.06188267968434822 +0.476 0.6361852739746816 0.6361828041923246 8.337573551842059e-07 -0.061892052634612116 +0.4761 0.6362036949695018 0.63620120843882 8.208882337767953e-07 -0.06190142382253011 +0.47620000000000007 0.6362221118439803 0.6362196088151104 8.078586194171233e-07 -0.061910793248166764 +0.4763 0.6362405245970463 0.6362380053232148 7.946709390249662e-07 -0.06192016091158684 +0.47640000000000005 0.6362589332276524 0.6362563979651288 7.813276493295884e-07 -0.061929526812855185 +0.4765 0.6362773377347752 0.636274786742824 7.67831236453409e-07 -0.0619388909520368 +0.4766 0.6362957381174159 0.6362931716582486 7.541842154124012e-07 -0.061948253329196845 +0.47670000000000007 0.6363141343745995 0.6363115527133261 7.403891296442477e-07 -0.06195761394440056 +0.4768 0.636332526505376 0.6363299299099556 7.264485505087404e-07 -0.06196697279771336 +0.47690000000000005 0.6363509145088211 0.6363483032500118 7.123650770379797e-07 -0.06197632988920091 +0.477 0.6363692983840349 0.6363666727353441 6.98141335103708e-07 -0.061985685218928804 +0.4771 0.6363876781301434 0.6363850383677765 6.837799771952646e-07 -0.0619950387869629 +0.47720000000000007 0.6364060537462991 0.6364034001491078 6.692836817950854e-07 -0.06200439059336924 +0.4773 0.6364244252316793 0.6364217580811106 6.546551528513467e-07 -0.06201374063821385 +0.47740000000000005 0.6364427925854889 0.6364401121655314 6.398971194726544e-07 -0.06202308892156301 +0.4775 0.6364611558069585 0.6364584624040911 6.250123352202763e-07 -0.062032435443483115 +0.4776 0.6364795148953457 0.6364768087984833 6.100035776640533e-07 -0.06204178020404068 +0.47770000000000007 0.6364978698499355 0.636495151350375 5.948736479105543e-07 -0.06205112320330234 +0.4778 0.63651622067004 0.6365134900614065 5.796253700479648e-07 -0.062060464441334943 +0.47790000000000005 0.6365345673549985 0.6365318249331906 5.64261590549342e-07 -0.06206980391820538 +0.478 0.6365529099041782 0.6365501559673128 5.487851778840369e-07 -0.06207914163398074 +0.4781 0.6365712483169745 0.6365684831653309 5.331990218654381e-07 -0.06208847758872824 +0.47820000000000007 0.6365895825928105 0.6365868065287749 5.17506033179127e-07 -0.0620978117825152 +0.4783 0.636607912731138 0.6366051260591468 5.017091428000109e-07 -0.06210714421540915 +0.47840000000000005 0.636626238731437 0.6366234417579202 4.858113014649668e-07 -0.06211647488747768 +0.4785 0.6366445605932165 0.6366417536265404 4.698154791316078e-07 -0.06212580379878856 +0.4786 0.6366628783160141 0.6366600616664239 4.5372466442317183e-07 -0.06213513094940967 +0.47870000000000007 0.636681191899397 0.6366783658789587 4.3754186410116525e-07 -0.06214445633940907 +0.4788 0.636699501342961 0.6366966662655034 4.212701024408627e-07 -0.062153779968854905 +0.47890000000000005 0.6367178066463317 0.6367149628273877 4.0491242063456223e-07 -0.06216310183781548 +0.479 0.6367361078091645 0.636733255565912 3.8847187631974034e-07 -0.06217242194635924 +0.4791 0.636754404831144 0.6367515444823474 3.719515430378184e-07 -0.0621817402945548 +0.47920000000000007 0.6367726977119853 0.6367698295779347 3.553545095819066e-07 -0.06219105688247082 +0.4793 0.6367909864514332 0.6367881108538858 3.386838793584257e-07 -0.06220037171017622 +0.47940000000000005 0.6368092710492629 0.6368063883113819 3.2194276992913995e-07 -0.062209684777739964 +0.4795 0.6368275515052793 0.6368246619515747 3.0513431244216793e-07 -0.06221899608523114 +0.4796 0.6368458278193189 0.6368429317755852 2.882616509103375e-07 -0.06222830563271904 +0.47970000000000007 0.6368640999912477 0.6368611977845045 2.7132794176015773e-07 -0.06223761342027304 +0.4798 0.6368823680209631 0.636879459979393 2.5433635313792946e-07 -0.06224691944796268 +0.47990000000000005 0.6369006319083931 0.6368977183612811 2.372900644170839e-07 -0.06225622371585765 +0.48 0.6369188916534967 0.6369159729311676 2.2019226550429316e-07 -0.062265526224027756 +0.4801 0.6369371472562637 0.6369342236900215 2.0304615631905332e-07 -0.06227482697254292 +0.48020000000000007 0.6369553987167152 0.6369524706387801 1.8585494614836717e-07 -0.06228412596147323 +0.4803 0.6369736460349037 0.6369707137783507 1.686218530985717e-07 -0.0622934231908889 +0.48040000000000005 0.6369918892109125 0.6369889531096086 1.513501034083875e-07 -0.06230271866086026 +0.4805 0.6370101282448571 0.6370071886333987 1.3404293094237962e-07 -0.06231201237145783 +0.4806 0.6370283631368836 0.637025420350534 1.1670357652482366e-07 -0.062321304322752215 +0.48070000000000007 0.6370465938871702 0.6370436482617969 9.933528734296093e-08 -0.062330594514814146 +0.4808 0.6370648204959263 0.6370618723679387 8.194131635025359e-08 -0.062339882947714545 +0.48090000000000005 0.6370830429633932 0.637080092669678 6.452492163841472e-08 -0.06234916962152444 +0.481 0.637101261289844 0.6370983091677036 4.708936585107182e-08 -0.06235845453631499 +0.4811 0.6371194754755833 0.6371165218626719 2.9637915569674655e-08 -0.06236773769215749 +0.48120000000000007 0.6371376855209475 0.6371347307552078 1.2173840666443447e-08 -0.06237701908912339 +0.4813 0.6371558914263049 0.637152935845905 -5.299586266355183e-09 -0.06238629872728423 +0.48140000000000005 0.6371740931920555 0.6371711371353257 -2.277909054958227e-08 -0.06239557660671174 +0.4815 0.6371922908186312 0.637189334624 -4.0261396029150215e-08 -0.06240485272747775 +0.48160000000000003 0.637210484306496 0.6372075283124269 -5.7743225692716976e-08 -0.062414127089654214 +0.4817000000000001 0.6372286736561456 0.6372257182010735 -7.522130227987506e-08 -0.062423399693313286 +0.4818 0.6372468588681074 0.6372439042903756 -9.269234889971306e-08 -0.062432670538527205 +0.48190000000000005 0.637265039942941 0.637262086580737 -1.1015308965314774e-07 -0.06244193962536833 +0.482 0.6372832168812377 0.6372802650725302 -1.2760025022706678e-07 -0.06245120695390917 +0.48210000000000003 0.6373013896836206 0.6372984397660961 -1.4503055853661018e-07 -0.062460472524222405 +0.4822000000000001 0.6373195583507446 0.6373166106617438 -1.6244074531324149e-07 -0.062469736336380755 +0.4823 0.6373377228832966 0.6373347777597512 -1.7982754474399343e-07 -0.06247899839045722 +0.48240000000000005 0.637355883281995 0.6373529410603644 -1.9718769506474332e-07 -0.062488258686524814 +0.4825 0.6373740395475905 0.6373711005637983 -2.1451793919338713e-07 -0.06249751722465674 +0.48260000000000003 0.6373921916808647 0.6373892562702362 -2.3181502531097187e-07 -0.06250677400492631 +0.4827 0.6374103396826314 0.6374074081798303 -2.4907570751742103e-07 -0.06251602902740698 +0.4828 0.6374284835537358 0.6374255562927009 -2.662967463831767e-07 -0.06252528229217234 +0.48290000000000005 0.6374466232950544 0.6374437006089377 -2.8347490964308886e-07 -0.06253453379929612 +0.483 0.6374647589074951 0.6374618411285989 -3.0060697271683257e-07 -0.06254378354885211 +0.48310000000000003 0.6374828903919978 0.6374799778517117 -3.176897193507555e-07 -0.0625530315409144 +0.4832 0.6375010177495332 0.6374981107782725 -3.3471994224931745e-07 -0.0625622777755571 +0.4833 0.6375191409811032 0.6375162399082461 -3.5169444362326274e-07 -0.06257152225285444 +0.48340000000000005 0.637537260087741 0.6375343652415675 -3.686100358904487e-07 -0.06258076497288086 +0.4835 0.6375553750705107 0.6375524867781398 -3.8546354211993483e-07 -0.06259000593571086 +0.48360000000000003 0.6375734859305072 0.6375706045178363 -4.022517968021999e-07 -0.06259924514141908 +0.4837 0.637591592668856 0.6375887184604994 -4.1897164632098693e-07 -0.06260848259008032 +0.4838 0.6376096952867141 0.6376068286059408 -4.3561994959862016e-07 -0.06261771828176954 +0.48390000000000005 0.6376277937852682 0.6376249349539428 -4.5219357869275e-07 -0.0626269522165618 +0.484 0.637645888165736 0.6376430375042569 -4.6868941937228126e-07 -0.0626361843945323 +0.48410000000000003 0.6376639784293651 0.6376611362566048 -4.851043716308512e-07 -0.06264541481575636 +0.4842 0.6376820645774333 0.637679231210678 -5.014353504917413e-07 -0.06265464348030944 +0.4843 0.6377001466112489 0.6376973223661386 -5.176792863131885e-07 -0.06266387038826715 +0.48440000000000005 0.6377182245321492 0.6377154097226191 -5.338331255932971e-07 -0.06267309553970526 +0.4845 0.6377362983415021 0.6377334932797223 -5.498938314418833e-07 -0.0626823189346996 +0.48460000000000003 0.6377543680407043 0.6377515730370217 -5.658583840800757e-07 -0.06269154057332614 +0.4847 0.6377724336311823 0.637769648994062 -5.817237816035936e-07 -0.06270076045566103 +0.4848 0.6377904951143918 0.6377877211503588 -5.974870403990806e-07 -0.06270997858178055 +0.48490000000000005 0.6378085524918176 0.6378057895053989 -6.131451957408496e-07 -0.06271919495176112 +0.485 0.6378266057649727 0.6378238540586403 -6.286953023598718e-07 -0.06272840956567918 +0.48510000000000003 0.6378446549353998 0.6378419148095134 -6.44134435040522e-07 -0.06273762242361151 +0.4852 0.6378627000046692 0.6378599717574195 -6.594596891201787e-07 -0.06274683352563484 +0.4853 0.6378807409743797 0.6378780249017322 -6.746681810720911e-07 -0.06275604287182611 +0.48540000000000005 0.6378987778461584 0.6378960742417972 -6.897570490049798e-07 -0.06276525046226236 +0.4855 0.63791681062166 0.6379141197769331 -7.047234532042701e-07 -0.0627744562970208 +0.48560000000000003 0.6379348393025667 0.6379321615064311 -7.19564576742715e-07 -0.06278366037617876 +0.4857 0.6379528638905886 0.6379501994295543 -7.342776259661177e-07 -0.06279286269981374 +0.4858 0.6379708843874626 0.63796823354554 -7.488598310068095e-07 -0.06280206326800325 +0.48590000000000005 0.6379889007949529 0.6379862638535986 -7.633084463387618e-07 -0.06281126208082513 +0.486 0.6380069131148496 0.6380042903529132 -7.77620751277186e-07 -0.06282045913835711 +0.48610000000000003 0.6380249213489703 0.6380223130426415 -7.917940505752785e-07 -0.06282965444067727 +0.4862 0.638042925499158 0.6380403319219152 -8.058256747711656e-07 -0.06283884798786367 +0.4863 0.6380609255672822 0.63805834698984 -8.197129808817927e-07 -0.06284803977999463 +0.48640000000000005 0.6380789215552383 0.6380763582454964 -8.334533526666021e-07 -0.0628572298171485 +0.4865 0.6380969134649461 0.6380943656879391 -8.470442014463231e-07 -0.06286641809940376 +0.48660000000000003 0.6381149012983518 0.6381123693161986 -8.604829662972602e-07 -0.0628756046268391 +0.4867 0.6381328850574259 0.6381303691292806 -8.737671146064052e-07 -0.06288478939953329 +0.4868 0.6381508647441638 0.6381483651261659 -8.868941427375709e-07 -0.06289397241756524 +0.48690000000000005 0.6381688403605852 0.6381663573058121 -8.998615762534357e-07 -0.06290315368101405 +0.487 0.6381868119087335 0.6381843456671518 -9.126669706371882e-07 -0.0629123331899588 +0.48710000000000003 0.6382047793906768 0.6382023302090951 -9.253079115145724e-07 -0.0629215109444789 +0.4872 0.6382227428085054 0.6382203109305286 -9.3778201526451e-07 -0.06293068694465373 +0.4873 0.6382407021643343 0.6382382878303154 -9.500869293244119e-07 -0.06293986119056288 +0.48740000000000006 0.6382586574602999 0.6382562609072965 -9.622203330228452e-07 -0.06294903368228602 +0.4875 0.6382766086985624 0.6382742301602905 -9.741799374962667e-07 -0.062958204419903 +0.48760000000000003 0.6382945558813036 0.6382921955880939 -9.859634863829125e-07 -0.06296737340349383 +0.4877 0.6383124990107276 0.6383101571894817 -9.975687562668867e-07 -0.0629765406331386 +0.4878 0.63833043808906 0.638328114963207 -1.0089935571500064e-06 -0.06298570610891745 +0.48790000000000006 0.6383483731185478 0.6383460689080025 -1.0202357327848688e-06 -0.06299486983091084 +0.488 0.6383663041014587 0.6383640190225792 -1.0312931608968956e-06 -0.06300403179919921 +0.48810000000000003 0.6383842310400816 0.6383819653056291 -1.0421637540725115e-06 -0.06301319201386323 +0.4882 0.6384021539367248 0.6383999077558227 -1.0528454597868997e-06 -0.06302235047498354 +0.4883 0.6384200727937179 0.6384178463718116 -1.0633362608203356e-06 -0.06303150718264114 +0.48840000000000006 0.6384379876134092 0.6384357811522284 -1.0736341757300316e-06 -0.06304066213691703 +0.4885 0.6384558983981665 0.6384537120956852 -1.083737259044426e-06 -0.06304981533789229 +0.48860000000000003 0.6384738051503768 0.6384716392007771 -1.0936436021791174e-06 -0.06305896678564826 +0.4887 0.6384917078724452 0.6384895624660796 -1.1033513330760414e-06 -0.06306811648026636 +0.4888 0.6385096065667956 0.6385074818901509 -1.1128586170083832e-06 -0.0630772644218281 +0.48890000000000006 0.6385275012358691 0.638525397471531 -1.1221636570246663e-06 -0.06308641061041508 +0.489 0.6385453918821251 0.6385433092087434 -1.1312646938099746e-06 -0.06309555504610921 +0.48910000000000003 0.6385632785080396 0.6385612171002942 -1.1401600063243311e-06 -0.06310469772899234 +0.4892 0.6385811611161054 0.6385791211446731 -1.1488479122467865e-06 -0.06311383865914658 +0.4893 0.6385990397088317 0.6385970213403539 -1.1573267680864419e-06 -0.06312297783665409 +0.48940000000000006 0.6386169142887442 0.6386149176857943 -1.1655949697098045e-06 -0.06313211526159723 +0.4895 0.6386347848583833 0.6386328101794365 -1.1736509524795657e-06 -0.06314125093405835 +0.48960000000000004 0.6386526514203055 0.6386506988197082 -1.1814931914766458e-06 -0.0631503848541201 +0.4897 0.6386705139770819 0.6386685836050224 -1.1891202019720382e-06 -0.06315951702186523 +0.4898 0.6386883725312976 0.6386864645337775 -1.1965305396766102e-06 -0.06316864743737652 +0.48990000000000006 0.6387062270855527 0.6387043416043587 -1.2037228009631473e-06 -0.06317777610073698 +0.49 0.6387240776424603 0.6387222148151375 -1.2106956233104427e-06 -0.06318690301202973 +0.49010000000000004 0.6387419242046468 0.6387400841644713 -1.2174476853310523e-06 -0.06319602817133793 +0.4902 0.6387597667747518 0.6387579496507065 -1.223977706854562e-06 -0.06320515157874494 +0.4903 0.638777605355427 0.6387758112721766 -1.2302844498712773e-06 -0.0632142732343343 +0.49040000000000006 0.6387954399493367 0.6387936690272034 -1.2363667181436444e-06 -0.06322339313818963 +0.4905 0.6388132705591563 0.6388115229140968 -1.242223357622585e-06 -0.06323251129039463 +0.49060000000000004 0.6388310971875726 0.638829372931156 -1.2478532568083178e-06 -0.06324162769103318 +0.4907 0.6388489198372836 0.6388472190766703 -1.2532553467226037e-06 -0.06325074234018935 +0.4908 0.6388667385109976 0.6388650613489175 -1.2584286011585455e-06 -0.06325985523794724 +0.49090000000000006 0.6388845532114327 0.6388828997461669 -1.2633720371524326e-06 -0.06326896638439113 +0.491 0.6389023639413165 0.6389007342666775 -1.268084714955986e-06 -0.06327807577960537 +0.49110000000000004 0.6389201707033861 0.6389185649086997 -1.2725657381196243e-06 -0.06328718342367454 +0.4912 0.6389379735003874 0.6389363916704758 -1.2768142539087979e-06 -0.06329628931668327 +0.4913 0.6389557723350741 0.6389542145502394 -1.2808294533317444e-06 -0.06330539345871633 +0.49140000000000006 0.6389735672102084 0.6389720335462168 -1.2846105713337774e-06 -0.06331449584985864 +0.4915 0.6389913581285597 0.6389898486566269 -1.2881568869360649e-06 -0.06332359649019526 +0.49160000000000004 0.6390091450929042 0.6390076598796821 -1.291467723346651e-06 -0.06333269537981132 +0.4917 0.6390269281060255 0.639025467213588 -1.2945424481825007e-06 -0.06334179251879211 +0.4918 0.6390447071707126 0.6390432706565445 -1.2973804734139893e-06 -0.06335088790722314 +0.49190000000000006 0.6390624822897607 0.6390610702067463 -1.299981255725724e-06 -0.06335998154518994 +0.492 0.6390802534659702 0.6390788658623825 -1.302344296599811e-06 -0.06336907343277819 +0.49210000000000004 0.639098020702146 0.6390966576216375 -1.3044691422048338e-06 -0.06337816357007359 +0.4922 0.6391157840010984 0.6391144454826921 -1.306355383590141e-06 -0.06338725195716223 +0.4923 0.6391335433656404 0.6391322294437229 -1.3080026567691139e-06 -0.06339633859413012 +0.49240000000000006 0.6391512987985899 0.6391500095029033 -1.3094106429689667e-06 -0.06340542348106346 +0.4925 0.6391690503027669 0.6391677856584037 -1.3105790684919683e-06 -0.06341450661804857 +0.49260000000000004 0.6391867978809949 0.639185557908392 -1.3115077046876866e-06 -0.0634235880051719 +0.4927 0.6392045415360992 0.6392033262510346 -1.312196368286056e-06 -0.06343266764252008 +0.4928 0.639222281270907 0.6392210906844956 -1.3126449212308433e-06 -0.06344174553017977 +0.49290000000000006 0.6392400170882466 0.6392388512069385 -1.3128532709294483e-06 -0.06345082166823783 +0.493 0.6392577489909481 0.6392566078165257 -1.3128213698643254e-06 -0.06345989605678123 +0.49310000000000004 0.6392754769818414 0.6392743605114197 -1.3125492159815622e-06 -0.06346896869589709 +0.4932 0.6392932010637564 0.639292109289783 -1.312036852552101e-06 -0.06347803958567257 +0.4933 0.6393109212395228 0.6393098541497787 -1.3112843683937836e-06 -0.06348710872619505 +0.49340000000000006 0.6393286375119698 0.6393275950895712 -1.310291897399507e-06 -0.06349617611755203 +0.4935 0.6393463498839247 0.6393453321073258 -1.3090596189535564e-06 -0.06350524175983108 +0.49360000000000004 0.6393640583582136 0.6393630652012108 -1.3075877575985384e-06 -0.06351430565311997 +0.4937 0.6393817629376604 0.6393807943693959 -1.3058765833962038e-06 -0.06352336779750653 +0.4938 0.6393994636250862 0.639398519610054 -1.3039264113445803e-06 -0.06353242819307879 +0.49390000000000006 0.639417160423309 0.6394162409213615 -1.3017376017665505e-06 -0.06354148683992482 +0.494 0.6394348533351439 0.6394339583014983 -1.2993105600045407e-06 -0.06355054373813292 +0.49410000000000004 0.6394525423634017 0.639451671748648 -1.2966457366148099e-06 -0.06355959888779142 +0.49420000000000003 0.6394702275108886 0.6394693812609997 -1.2937436268123381e-06 -0.06356865228898882 +0.4943 0.6394879087804061 0.6394870868367468 -1.2906047708038937e-06 -0.06357770394181375 +0.49440000000000006 0.6395055861747512 0.6395047884740885 -1.2872297536214994e-06 -0.06358675384635495 +0.4945 0.6395232596967144 0.6395224861712296 -1.2836192051501882e-06 -0.0635958020027013 +0.49460000000000004 0.6395409293490807 0.6395401799263816 -1.2797737994618696e-06 -0.06360484841094183 +0.49470000000000003 0.6395585951346283 0.6395578697377625 -1.275694255231663e-06 -0.0636138930711657 +0.4948 0.6395762570561283 0.6395755556035975 -1.2713813354325865e-06 -0.0636229359834621 +0.4949 0.6395939151163447 0.6395932375221197 -1.2668358471967789e-06 -0.06363197714792045 +0.495 0.6396115693180336 0.6396109154915698 -1.262058641621211e-06 -0.0636410165646303 +0.49510000000000004 0.6396292196639429 0.6396285895101972 -1.2570506138509518e-06 -0.0636500542336812 +0.49520000000000003 0.6396468661568118 0.6396462595762604 -1.2518127025795689e-06 -0.06365909015516301 +0.4953 0.6396645087993704 0.639663925688027 -1.2463458899936164e-06 -0.06366812432916556 +0.4954 0.6396821475943394 0.6396815878437745 -1.2406512016338578e-06 -0.06367715675577894 +0.4955 0.6396997825444293 0.6396992460417903 -1.2347297064507767e-06 -0.06368618743509326 +0.49560000000000004 0.6397174136523405 0.6397169002803726 -1.2285825160829322e-06 -0.0636952163671988 +0.49570000000000003 0.6397350409207625 0.6397345505578307 -1.2222107850790032e-06 -0.06370424355218594 +0.4958 0.6397526643523734 0.6397521968724852 -1.215615710453699e-06 -0.0637132689901452 +0.4959 0.6397702839498405 0.6397698392226683 -1.2087985316044936e-06 -0.06372229268116725 +0.496 0.6397878997158184 0.6397874776067252 -1.2017605299785572e-06 -0.0637313146253429 +0.49610000000000004 0.6398055116529491 0.6398051120230127 -1.1945030290727576e-06 -0.063740334822763 +0.49620000000000003 0.6398231197638622 0.6398227424699017 -1.1870273937397702e-06 -0.0637493532735186 +0.4963 0.6398407240511741 0.639840368945776 -1.1793350302713446e-06 -0.06375836997770089 +0.4964 0.6398583245174871 0.6398579914490333 -1.1714273862872826e-06 -0.0637673849354011 +0.4965 0.63987592116539 0.6398756099780856 -1.163305949902771e-06 -0.06377639814671061 +0.49660000000000004 0.6398935139974571 0.63989322453136 -1.1549722500059367e-06 -0.06378540961172106 +0.49670000000000003 0.6399111030162472 0.639910835107298 -1.1464278558415142e-06 -0.06379441933052403 +0.4968 0.6399286882243049 0.6399284417043569 -1.1376743764279773e-06 -0.06380342730321131 +0.4969 0.6399462696241586 0.6399460443210099 -1.1287134605852955e-06 -0.06381243352987485 +0.497 0.6399638472183204 0.6399636429557464 -1.119546796657378e-06 -0.06382143801060668 +0.49710000000000004 0.6399814210092869 0.6399812376070724 -1.110176111762673e-06 -0.06383044074549896 +0.49720000000000003 0.6399989909995372 0.6399988282735107 -1.1006031719329457e-06 -0.06383944173464394 +0.4973 0.6400165571915333 0.6400164149536018 -1.0908297817247004e-06 -0.06384844097813407 +0.4974 0.64003411958772 0.6400339976459037 -1.0808577835530464e-06 -0.06385743847606183 +0.4975 0.6400516781905244 0.6400515763489928 -1.0706890576916983e-06 -0.06386643422852 +0.49760000000000004 0.640069233002355 0.6400691510614636 -1.060325521801131e-06 -0.06387542823560126 +0.49770000000000003 0.6400867840256016 0.6400867217819297 -1.0497691305122459e-06 -0.06388442049739858 +0.4978 0.6401043312626352 0.6401042885090238 -1.0390218752320823e-06 -0.06389341101400497 +0.4979 0.6401218747158076 0.6401218512413982 -1.0280857836719726e-06 -0.06390239978551362 +0.498 0.6401394143874507 0.6401394099777254 -1.0169629193479413e-06 -0.06391138681201781 +0.49810000000000004 0.6401569502798763 0.6401569647166977 -1.0056553812476388e-06 -0.06392037209361094 +0.49820000000000003 0.640174482395376 0.6401745154570282 -9.9416530377483e-07 -0.06392935563038653 +0.4983 0.6401920107362206 0.6401920621974508 -9.824948557224378e-07 -0.06393833742243826 +0.4984 0.64020953530466 0.6402096049367213 -9.706462405223437e-07 -0.06394731746985992 +0.4985 0.6402270561029226 0.6402271436736163 -9.586216952739424e-07 -0.06395629577274545 +0.49860000000000004 0.6402445731332153 0.6402446784069351 -9.464234907718971e-07 -0.06396527233118887 +0.49870000000000003 0.6402620863977222 0.6402622091354986 -9.340539307567397e-07 -0.06397424714528431 +0.4988 0.640279595898606 0.6402797358581508 -9.215153516928254e-07 -0.0639832202151261 +0.4989 0.640297101638006 0.6402972585737585 -9.088101221021994e-07 -0.06399219154080862 +0.499 0.6403146036180389 0.6403147772812114 -8.959406425090854e-07 -0.06400116112242639 +0.49910000000000004 0.6403321018407979 0.6403322919794233 -8.829093444961966e-07 -0.0640101289600741 +0.49920000000000003 0.6403495963083525 0.6403498026673313 -8.697186907880017e-07 -0.06401909505384647 +0.4993 0.6403670870227489 0.6403673093438974 -8.563711741960134e-07 -0.06402805940383853 +0.4994 0.6403845739860083 0.6403848120081072 -8.428693175355217e-07 -0.0640370220101452 +0.4995 0.6404020572001277 0.6404023106589714 -8.292156732647715e-07 -0.06404598287286167 +0.49960000000000004 0.6404195366670795 0.6404198052955256 -8.154128225412727e-07 -0.06405494199208321 +0.49970000000000003 0.6404370123888107 0.6404372959168312 -8.014633751662892e-07 -0.06406389936790526 +0.4998 0.640454484367243 0.6404547825219747 -7.873699688909497e-07 -0.0640728550004233 +0.4999 0.6404719526042729 0.6404722651100684 -7.73135268986036e-07 -0.064081808889733 +0.5 0.6404894171017705 0.6404897436802508 -7.587619676313606e-07 -0.0640907610359301 +0.5001 0.6405068778615803 0.6405072182316871 -7.442527836243329e-07 -0.06409971143911057 +0.5002000000000001 0.6405243348855197 0.6405246887635686 -7.296104616444365e-07 -0.06410866009937036 +0.5003 0.6405417881753801 0.640542155275114 -7.148377718230181e-07 -0.06411760701680565 +0.5004000000000001 0.6405592377329256 0.6405596177655689 -6.999375093269533e-07 -0.0641265521915127 +0.5005 0.6405766835598931 0.640577076234206 -6.849124936231243e-07 -0.06413549562358789 +0.5006 0.6405941256579923 0.6405945306803263 -6.697655680620862e-07 -0.06414443731312777 +0.5007 0.6406115640289052 0.640611981103258 -6.544995993923441e-07 -0.06415337726022889 +0.5008 0.6406289986742859 0.6406294275023576 -6.39117477149731e-07 -0.06416231546498809 +0.5009 0.640646429595761 0.6406468698770099 -6.236221131578068e-07 -0.06417125192750221 +0.501 0.640663856794928 0.6406643082266286 -6.080164408339694e-07 -0.06418018664786833 +0.5011 0.6406812802733564 0.6406817425506552 -5.923034148980211e-07 -0.06418911962618348 +0.5012000000000001 0.6406987000325867 0.6406991728485615 -5.764860105395009e-07 -0.06419805086254499 +0.5013 0.6407161160741306 0.6407165991198469 -5.605672230568626e-07 -0.06420698035705018 +0.5014000000000001 0.6407335283994707 0.6407340213640412 -5.445500671913406e-07 -0.06421590810979658 +0.5015 0.6407509370100607 0.6407514395807032 -5.284375765579608e-07 -0.0642248341208818 +0.5016 0.6407683419073241 0.6407688537694218 -5.122328032014511e-07 -0.06423375839040357 +0.5017 0.6407857430926553 0.6407862639298153 -4.959388167635748e-07 -0.06424268091845978 +0.5018 0.6408031405674189 0.6408036700615325 -4.795587042055738e-07 -0.06425160170514842 +0.5019 0.6408205343329494 0.640821072164252 -4.6309556890611336e-07 -0.06426052075056758 +0.502 0.6408379243905504 0.6408384702376831 -4.465525303976037e-07 -0.06426943805481551 +0.5021 0.6408553107414966 0.6408558642815656 -4.299327235474104e-07 -0.06427835361799056 +0.5022000000000001 0.6408726933870311 0.6408732542956697 -4.132392980721322e-07 -0.06428726744019118 +0.5023 0.640890072328367 0.6408906402797968 -3.9647541780207796e-07 -0.064296179521516 +0.5024000000000001 0.6409074475666865 0.6409080222337789 -3.7964426035513865e-07 -0.06430508986206375 +0.5025 0.6409248191031409 0.6409254001574796 -3.627490162486091e-07 -0.06431399846193324 +0.5026 0.6409421869388505 0.6409427740507929 -3.4579288848979317e-07 -0.06432290532122346 +0.5027 0.6409595510749047 0.6409601439136453 -3.287790918682365e-07 -0.06433181044003355 +0.5028 0.6409769115123611 0.6409775097459937 -3.1171085235898177e-07 -0.06434071381846264 +0.5029 0.6409942682522466 0.6409948715478269 -2.9459140649806814e-07 -0.06434961545661007 +0.503 0.6410116212955563 0.6410122293191657 -2.774240008482365e-07 -0.06435851535457533 +0.5031 0.6410289706432539 0.6410295830600623 -2.6021189131197886e-07 -0.06436741351245798 +0.5032000000000001 0.6410463162962714 0.6410469327706008 -2.4295834255561033e-07 -0.06437630993035773 +0.5033 0.6410636582555092 0.6410642784508971 -2.2566662735007403e-07 -0.06438520460837434 +0.5034000000000001 0.6410809965218355 0.6410816201010998 -2.0834002594644074e-07 -0.0643940975466078 +0.5035 0.6410983310960873 0.6410989577213888 -1.9098182553814458e-07 -0.06440298874515818 +0.5036 0.6411156619790692 0.6411162913119764 -1.7359531953239915e-07 -0.06441187820412565 +0.5037 0.6411329891715539 0.6411336208731073 -1.5618380696733047e-07 -0.0644207659236105 +0.5038 0.6411503126742821 0.6411509464050583 -1.3875059191870154e-07 -0.06442965190371314 +0.5039 0.6411676324879625 0.6411682679081386 -1.212989828337785e-07 -0.06443853614453418 +0.504 0.6411849486132711 0.6411855853826897 -1.038322918998913e-07 -0.06444741864617423 +0.5041 0.6412022610508528 0.6412028988290857 -8.635383443207634e-08 -0.06445629940873412 +0.5042000000000001 0.641219569801319 0.6412202082477327 -6.886692823990237e-08 -0.06446517843231474 +0.5043 0.6412368748652499 0.6412375136390697 -5.1374893002102684e-08 -0.0644740557170171 +0.5044000000000001 0.641254176243193 0.641254815003568 -3.388104962429375e-08 -0.0644829312629424 +0.5045 0.6412714739356636 0.6412721123417313 -1.6388719614257932e-08 -0.06449180507019191 +0.5046 0.6412887679431447 0.6412894056540961 1.0987755488453543e-09 -0.06450067713886698 +0.5047 0.6413060582660873 0.6413066949412305 1.8578115044617927e-08 -0.06450954746906913 +0.5048 0.6413233449049097 0.6413239802037362 3.604597934372955e-08 -0.06451841606090002 +0.5049 0.6413406278599985 0.6413412614422469 5.3499050843910934e-08 -0.06452728291446141 +0.505 0.6413579071317073 0.6413585386574284 7.093401449206893e-08 -0.06453614802985515 +0.5051 0.6413751827203584 0.6413758118499797 8.834755842179742e-08 -0.06454501140718326 +0.5052000000000001 0.6413924546262414 0.6413930810206312 1.0573637458655138e-07 -0.06455387304654785 +0.5053 0.6414097228496137 0.6414103461701467 1.2309715937200427e-07 -0.06456273294805116 +0.5054000000000001 0.6414269873907008 0.6414276072993215 1.4042661425697767e-07 -0.06457159111179553 +0.5055 0.6414442482496963 0.6414448644089836 1.5772144639283892e-07 -0.06458044753788347 +0.5056 0.6414615054267614 0.641462117499993 1.749783692800433e-07 -0.06458930222641755 +0.5057 0.6414787589220261 0.6414793665732419 1.921941033614094e-07 -0.0645981551775005 +0.5058 0.6414960087355875 0.6414966116296545 2.0936537666743638e-07 -0.06460700639123516 +0.5059 0.641513254867512 0.6415138526701872 2.2648892543386534e-07 -0.06461585586772452 +0.506 0.6415304973178337 0.6415310896958281 2.435614946949549e-07 -0.0646247036070716 +0.5061 0.6415477360865554 0.6415483227075971 2.605798389565539e-07 -0.06463354960937967 +0.5062000000000001 0.6415649711736477 0.641565551706546 2.7754072279284614e-07 -0.06464239387475196 +0.5063 0.6415822025790505 0.6415827766937579 2.9444092140146205e-07 -0.06465123640329194 +0.5064000000000001 0.6415994303026725 0.6415999976703479 3.112772213320625e-07 -0.0646600771951032 +0.5065 0.6416166543443904 0.6416172146374625 3.280464210414502e-07 -0.0646689162502894 +0.5066 0.6416338747040506 0.6416344275962791 3.447453314417426e-07 -0.0646777535689543 +0.5067 0.6416510913814679 0.6416516365480065 3.613707766636498e-07 -0.06468658915120185 +0.5068 0.6416683043764269 0.6416688414938845 3.7791959449362533e-07 -0.06469542299713608 +0.5069 0.641685513688681 0.6416860424351841 3.9438863710938854e-07 -0.06470425510686116 +0.507 0.6417027193179534 0.641703239373207 4.1077477154483066e-07 -0.06471308548048137 +0.5071 0.6417199212639365 0.6417204323092849 4.2707488041859865e-07 -0.06472191411810106 +0.5072000000000001 0.6417371195262928 0.6417376212447805 4.432858625724734e-07 -0.06473074101982478 +0.5073 0.6417543141046543 0.6417548061810872 4.5940463336280324e-07 -0.06473956618575714 +0.5074000000000001 0.6417715049986235 0.6417719871196278 4.754281256597048e-07 -0.06474838961600288 +0.5075 0.641788692207773 0.6417891640618554 4.913532900829853e-07 -0.0647572113106669 +0.5076 0.6418058757316456 0.641806337009253 5.071770958486876e-07 -0.06476603126985421 +0.5077 0.6418230555697548 0.6418235059633333 5.22896531116035e-07 -0.06477484949366985 +0.5078 0.6418402317215851 0.6418406709256381 5.385086037784648e-07 -0.06478366598221912 +0.5079 0.6418574041865914 0.641857831897739 5.540103419493514e-07 -0.06479248073560731 +0.508 0.6418745729642001 0.6418749888812358 5.69398794419973e-07 -0.06480129375393988 +0.5081 0.6418917380538095 0.6418921418777581 5.846710313811565e-07 -0.06481010503732244 +0.5082000000000001 0.6419088994547884 0.6419092908889634 5.998241448812447e-07 -0.06481891458586068 +0.5083 0.6419260571664782 0.6419264359165382 6.148552495061077e-07 -0.06482772239966046 +0.5084000000000001 0.641943211188192 0.6419435769621967 6.297614828787435e-07 -0.06483652847882766 +0.5085 0.6419603615192151 0.6419607140276815 6.445400060062223e-07 -0.06484533282346835 +0.5086 0.6419775081588055 0.6419778471147627 6.591880041262321e-07 -0.06485413543368873 +0.5087 0.6419946511061937 0.641994976225238 6.737026871095342e-07 -0.06486293630959508 +0.5088 0.642011790360583 0.6420121013609323 6.880812900428301e-07 -0.06487173545129381 +0.5089 0.6420289259211502 0.6420292225236979 7.023210735757068e-07 -0.06488053285889143 +0.509 0.6420460577870455 0.642046339715413 7.164193247255479e-07 -0.06488932853249461 +0.5091 0.6420631859573924 0.6420634529379833 7.303733572383564e-07 -0.06489812247221009 +0.5092000000000001 0.6420803104312889 0.6420805621933403 7.441805120744771e-07 -0.06490691467814481 +0.5093 0.6420974312078069 0.6420976674834414 7.578381579775861e-07 -0.06491570515040572 +0.5094000000000001 0.6421145482859928 0.6421147688102701 7.71343692113069e-07 -0.06492449388909997 +0.5095 0.6421316616648676 0.6421318661758348 7.846945401790428e-07 -0.06493328089433474 +0.5096 0.642148771343428 0.6421489595821696 7.978881572667795e-07 -0.06494206616621744 +0.5097 0.6421658773206451 0.6421660490313331 8.109220283325502e-07 -0.06495084970485551 +0.5098 0.6421829795954666 0.6421831345254088 8.237936684751812e-07 -0.0649596315103566 +0.5099 0.6422000781668153 0.6422002160665041 8.365006236576988e-07 -0.06496841158282832 +0.51 0.6422171730335908 0.6422172936567507 8.49040470679574e-07 -0.06497718992237854 +0.5101 0.642234264194669 0.642234367298304 8.614108183979674e-07 -0.06498596652911524 +0.5102000000000001 0.6422513516489023 0.6422514369933425 8.736093076444629e-07 -0.06499474140314641 +0.5103 0.6422684353951212 0.6422685027440679 8.856336117801789e-07 -0.0650035145445803 +0.5104000000000001 0.6422855154321326 0.6422855645527047 8.974814372231243e-07 -0.06501228595352514 +0.5105 0.642302591758722 0.6423026224214997 9.091505238090214e-07 -0.06502105563008939 +0.5106 0.6423196643736524 0.642319676352722 9.206386453741722e-07 -0.06502982357438157 +0.5107 0.6423367332756655 0.6423367263486622 9.319436100607703e-07 -0.06503858978651025 +0.5108 0.642353798463482 0.6423537724116324 9.430632606777234e-07 -0.06504735426658427 +0.5109 0.6423708599358015 0.6423708145439658 9.539954753667867e-07 -0.0650561170147125 +0.511 0.642387917691303 0.6423878527480167 9.647381676580746e-07 -0.06506487803100393 +0.5111 0.6424049717286455 0.642404887026159 9.752892870806829e-07 -0.06507363731556769 +0.5112000000000001 0.6424220220464683 0.6424219173807875 9.856468197733115e-07 -0.06508239486851293 +0.5113 0.6424390686433906 0.6424389438143158 9.958087882344646e-07 -0.06509115068994907 +0.5114000000000001 0.6424561115180134 0.6424559663291776 1.0057732525436958e-06 -0.06509990477998558 +0.5115 0.6424731506689183 0.6424729849278252 1.0155383099452742e-06 -0.06510865713873201 +0.5116 0.6424901860946683 0.6424899996127293 1.0251020957641188e-06 -0.06511740776629803 +0.5117 0.6425072177938093 0.6425070103863795 1.034462783572332e-06 -0.06512615666279346 +0.5118 0.6425242457648686 0.6425240172512825 1.0436185854112434e-06 -0.06513490382832826 +0.5119 0.6425412700063566 0.642541020209963 1.052567752318767e-06 -0.06514364926301247 +0.512 0.6425582905167674 0.6425580192649623 1.0613085747179785e-06 -0.06515239296695623 +0.5121 0.6425753072945778 0.6425750144188387 1.0698393825836483e-06 -0.0651611349402698 +0.5122000000000001 0.6425923203382486 0.6425920056741669 1.0781585457753096e-06 -0.06516987518306364 +0.5123000000000001 0.6426093296462254 0.6426089930335377 1.0862644743980798e-06 -0.0651786136954482 +0.5124 0.6426263352169377 0.6426259764995566 1.094155619218995e-06 -0.0651873504775341 +0.5125 0.6426433370488008 0.6426429560748452 1.1018304718612981e-06 -0.06519608552943215 +0.5126000000000001 0.642660335140215 0.6426599317620394 1.10928756505424e-06 -0.06520481885125314 +0.5127 0.6426773294895667 0.6426769035637891 1.1165254729939011e-06 -0.06521355044310806 +0.5128 0.6426943200952284 0.642693871482759 1.1235428115929924e-06 -0.06522228030510799 +0.5129 0.6427113069555596 0.6427108355216264 1.130338238591877e-06 -0.06523100843736412 +0.513 0.6427282900689064 0.6427277956830824 1.1369104542802155e-06 -0.0652397348399878 +0.5131 0.6427452694336028 0.6427447519698302 1.1432582013304327e-06 -0.06524845951309045 +0.5132000000000001 0.6427622450479706 0.6427617043845857 1.1493802650197615e-06 -0.06525718245678362 +0.5133000000000001 0.6427792169103199 0.6427786529300766 1.1552754737853554e-06 -0.06526590367117897 +0.5134 0.6427961850189496 0.6427955976090423 1.1609426992520433e-06 -0.06527462315638828 +0.5135 0.6428131493721481 0.6428125384242325 1.1663808564821299e-06 -0.06528334091252347 +0.5136000000000001 0.6428301099681928 0.6428294753784081 1.1715889040309069e-06 -0.06529205693969656 +0.5137 0.6428470668053516 0.6428464084743398 1.1765658445017646e-06 -0.06530077123801963 +0.5138 0.6428640198818825 0.6428633377148084 1.181310724407414e-06 -0.06530948380760492 +0.5139 0.6428809691960347 0.6428802631026039 1.18582263458622e-06 -0.06531819464856481 +0.514 0.6428979147460484 0.6428971846405251 1.19010071034098e-06 -0.06532690376101179 +0.5141 0.6429148565301563 0.642914102331379 1.1941441313556567e-06 -0.06533561114505841 +0.5142 0.6429317945465823 0.6429310161779811 1.197952122222734e-06 -0.06534431680081738 +0.5143000000000001 0.6429487287935437 0.6429479261831541 1.2015239524432175e-06 -0.06535302072840153 +0.5144 0.6429656592692505 0.6429648323497279 1.2048589365099005e-06 -0.0653617229279238 +0.5145 0.6429825859719064 0.6429817346805392 1.2079564340461424e-06 -0.06537042339949717 +0.5146000000000001 0.6429995088997085 0.6429986331784309 1.2108158500556687e-06 -0.06537912214323485 +0.5147 0.6430164280508491 0.6430155278462517 1.2134366348948156e-06 -0.0653878191592501 +0.5148 0.643033343423515 0.6430324186868556 1.2158182847443744e-06 -0.0653965144476563 +0.5149 0.6430502550158881 0.6430493057031016 1.2179603410544804e-06 -0.06540520800856697 +0.515 0.6430671628261467 0.643066188897853 1.2198623910719686e-06 -0.06541389984209577 +0.5151 0.6430840668524644 0.6430830682739774 1.2215240680624184e-06 -0.0654225899483564 +0.5152 0.6431009670930119 0.6430999438343457 1.222945051088109e-06 -0.06543127832746264 +0.5153000000000001 0.643117863545957 0.6431168155818321 1.2241250650635305e-06 -0.06543996497952852 +0.5154 0.6431347562094649 0.6431336835193133 1.2250638810884507e-06 -0.0654486499046681 +0.5155 0.6431516450816986 0.6431505476496686 1.2257613161703595e-06 -0.0654573331029956 +0.5156000000000001 0.6431685301608201 0.6431674079757785 1.2262172336130472e-06 -0.06546601457462527 +0.5157 0.6431854114449895 0.6431842645005252 1.2264315426557815e-06 -0.06547469431967154 +0.5158 0.6432022889323671 0.6432011172267917 1.22640419883413e-06 -0.06548337233824894 +0.5159 0.643219162621112 0.6432179661574613 1.2261352038411832e-06 -0.0654920486304721 +0.516 0.6432360325093844 0.6432348112954177 1.2256246055275533e-06 -0.06550072319645582 +0.5161 0.643252898595345 0.6432516526435434 1.2248724979013748e-06 -0.06550939603631493 +0.5162 0.6432697608771552 0.6432684902047208 1.2238790212115713e-06 -0.06551806715016446 +0.5163000000000001 0.643286619352978 0.6432853239818299 1.2226443618090777e-06 -0.06552673653811947 +0.5164 0.6433034740209794 0.6433021539777497 1.2211687520635728e-06 -0.06553540420029516 +0.5165 0.6433203248793267 0.6433189801953565 1.2194524706132803e-06 -0.06554407013680684 +0.5166000000000001 0.6433371719261907 0.6433358026375242 1.2174958419486348e-06 -0.06555273434777001 +0.5167 0.6433540151597456 0.6433526213071231 1.2152992366065707e-06 -0.06556139683330019 +0.5168 0.6433708545781696 0.6433694362070204 1.2128630710317445e-06 -0.06557005759351309 +0.5169 0.6433876901796443 0.6433862473400783 1.2101878075487793e-06 -0.06557871662852442 +0.517 0.643404521962357 0.6434030547091555 1.2072739540014421e-06 -0.06558737393845007 +0.5171 0.6434213499245001 0.643419858317105 1.204122064335511e-06 -0.06559602952340608 +0.5172 0.6434381740642711 0.6434366581667748 1.200732737571819e-06 -0.06560468338350857 +0.5173000000000001 0.643454994379874 0.6434534542610064 1.1971066184723878e-06 -0.06561333551887377 +0.5174 0.6434718108695192 0.6434702466026356 1.193244396902049e-06 -0.06562198592961797 +0.5175 0.643488623531424 0.6434870351944912 1.1891468082170231e-06 -0.06563063461585768 +0.5176000000000001 0.6435054323638132 0.6435038200393953 1.1848146326542963e-06 -0.0656392815777095 +0.5177 0.6435222373649194 0.6435206011401613 1.1802486953038649e-06 -0.06564792681529007 +0.5178 0.6435390385329833 0.6435373784995955 1.175449866192002e-06 -0.06565657032871615 +0.5179 0.6435558358662549 0.6435541521204949 1.1704190598649244e-06 -0.06566521211810471 +0.518 0.6435726293629924 0.6435709220056478 1.1651572353332806e-06 -0.06567385218357268 +0.5181 0.6435894190214647 0.6435876881578335 1.1596653958778624e-06 -0.06568249052523727 +0.5182 0.6436062048399498 0.6436044505798209 1.1539445888275601e-06 -0.06569112714321566 +0.5183000000000001 0.6436229868167368 0.643621209274369 1.1479959053650735e-06 -0.06569976203762531 +0.5184 0.6436397649501251 0.643637964244226 1.1418204803603782e-06 -0.06570839520858356 +0.5185 0.6436565392384258 0.6436547154921292 1.1354194921764371e-06 -0.06571702665620807 +0.5186000000000001 0.643673309679962 0.6436714630208037 1.1287941623083775e-06 -0.06572565638061649 +0.5187 0.6436900762730684 0.6436882068329632 1.12194575557778e-06 -0.06573428438192669 +0.5188 0.6437068390160925 0.6437049469313094 1.1148755791612341e-06 -0.06574291066025653 +0.5189 0.643723597907395 0.64372168331853 1.1075849830066709e-06 -0.06575153521572406 +0.519 0.6437403529453495 0.6437384159973005 1.1000753592504964e-06 -0.06576015804844741 +0.5191 0.6437571041283439 0.6437551449702825 1.092348142078814e-06 -0.06576877915854484 +0.5192 0.6437738514547802 0.6437718702401231 1.0844048074776236e-06 -0.06577739854613467 +0.5193000000000001 0.643790594923075 0.6437885918094557 1.076246872788733e-06 -0.06578601621133545 +0.5194 0.6438073345316602 0.6438053096808982 1.0678758965432245e-06 -0.06579463215426576 +0.5195 0.6438240702789827 0.6438220238570539 1.059293478322676e-06 -0.06580324637504424 +0.5196000000000001 0.6438408021635056 0.6438387343405095 1.0505012581762951e-06 -0.06581185887378975 +0.5197 0.6438575301837078 0.6438554411338364 1.041500916287852e-06 -0.06582046965062115 +0.5198 0.6438742543380858 0.6438721442395893 1.032294172947923e-06 -0.06582907870565752 +0.5199 0.6438909746251521 0.643888843660306 1.0228827880542912e-06 -0.06583768603901802 +0.52 0.643907691043437 0.6439055393985074 1.0132685609176573e-06 -0.06584629165082186 +0.5201 0.643924403591489 0.643922231456696 1.0034533296232606e-06 -0.06585489554118842 +0.5202 0.643941112267874 0.6439389198373576 9.934389710031244e-07 -0.06586349771023721 +0.5203000000000001 0.6439578170711773 0.6439556045429583 9.83227399997677e-07 -0.06587209815808778 +0.5204 0.6439745180000027 0.643972285575946 9.728205696002412e-07 -0.06588069688485984 +0.5205 0.643991215052973 0.6439889629387495 9.622204701908998e-07 -0.0658892938906732 +0.5206000000000001 0.6440079082287314 0.6440056366337783 9.51429129425474e-07 -0.0658978891756478 +0.5207 0.6440245975259409 0.6440223066634218 9.404486116526556e-07 -0.06590648273990367 +0.5208 0.6440412829432843 0.644038973030049 9.292810176086963e-07 -0.06591507458356094 +0.5209 0.644057964479466 0.6440556357360089 9.179284839733182e-07 -0.06592366470673987 +0.521 0.644074642133211 0.644072294783629 9.063931830088912e-07 -0.06593225310956083 +0.5211 0.6440913159032657 0.6440889501752158 8.946773220330773e-07 -0.06594083979214425 +0.5212 0.6441079857883986 0.6441056019130542 8.827831432800526e-07 -0.06594942475461074 +0.5213000000000001 0.6441246517874 0.6441222499994071 8.707129232343735e-07 -0.06595800799708103 +0.5214 0.6441413138990832 0.6441388944365153 8.584689722423988e-07 -0.06596658951967589 +0.5215 0.6441579721222841 0.6441555352265965 8.460536340404445e-07 -0.06597516932251625 +0.5216000000000001 0.6441746264558614 0.6441721723718461 8.334692853939618e-07 -0.06598374740572314 +0.5217 0.6441912768986977 0.6441888058744359 8.207183355701808e-07 -0.06599232376941773 +0.5218 0.6442079234496987 0.6442054357365139 8.078032259495327e-07 -0.06600089841372118 +0.5219 0.644224566107795 0.6442220619602045 7.947264294982936e-07 -0.06600947133875491 +0.522 0.644241204871941 0.644238684547608 7.814904504077624e-07 -0.06601804254464039 +0.5221 0.6442578397411162 0.6442553035007998 7.680978234281266e-07 -0.0660266120314992 +0.5222 0.6442744707143246 0.6442719188218309 7.545511136186622e-07 -0.06603517979945298 +0.5223000000000001 0.644291097790596 0.6442885305127267 7.408529155983334e-07 -0.06604374584862353 +0.5224 0.6443077209689856 0.6443051385754881 7.270058532959922e-07 -0.06605231017913282 +0.5225 0.6443243402485745 0.6443217430120892 7.130125793120001e-07 -0.06606087279110287 +0.5226000000000001 0.6443409556284699 0.6443383438244787 6.988757743353613e-07 -0.06606943368465572 +0.5227 0.6443575671078052 0.6443549410145792 6.845981469216778e-07 -0.06607799285991366 +0.5228 0.6443741746857409 0.6443715345842866 6.701824326882377e-07 -0.06608655031699902 +0.5229 0.644390778361464 0.6443881245354699 6.556313939254377e-07 -0.06609510605603428 +0.523 0.6444073781341892 0.644404710869971 6.409478190555484e-07 -0.06610366007714194 +0.5231 0.6444239740031587 0.6444212935896053 6.261345220498482e-07 -0.06611221238044475 +0.5232 0.6444405659676415 0.6444378726961597 6.111943418873889e-07 -0.06612076296606544 +0.5233000000000001 0.6444571540269358 0.6444544481913939 5.96130142221929e-07 -0.06612931183412694 +0.5234 0.6444737381803674 0.644471020077039 5.809448104659998e-07 -0.06613785898475222 +0.5235 0.6444903184272902 0.6444875883547987 5.656412575272274e-07 -0.0661464044180644 +0.5236000000000001 0.6445068947670876 0.6445041530263478 5.502224172115877e-07 -0.06615494813418675 +0.5237 0.6445234671991712 0.6445207140933317 5.346912455989061e-07 -0.0661634901332425 +0.5238 0.644540035722982 0.6445372715573677 5.190507204738681e-07 -0.06617203041535513 +0.5239 0.6445566003379903 0.6445538254200438 5.033038407015189e-07 -0.0661805689806482 +0.524 0.644573161043696 0.644570375682919 4.874536258941964e-07 -0.06618910582924535 +0.5241 0.6445897178396284 0.6445869223475219 4.7150311555110846e-07 -0.06619764096127037 +0.5242 0.6446062707253473 0.6446034654153521 4.554553685726104e-07 -0.06620617437684712 +0.5243000000000001 0.6446228197004418 0.644620004887879 4.393134628022377e-07 -0.06621470607609957 +0.5244 0.6446393647645323 0.6446365407665415 4.230804942634281e-07 -0.06622323605915183 +0.5245 0.6446559059172688 0.6446530730527491 4.0675957668767637e-07 -0.06623176432612807 +0.5246000000000001 0.6446724431583326 0.64466960174788 3.9035384087615643e-07 -0.06624029087715262 +0.5247 0.6446889764874351 0.644686126853282 3.738664340474651e-07 -0.06624881571234986 +0.5248 0.6447055059043191 0.644702648370272 3.573005192131218e-07 -0.06625733883184431 +0.5248999999999999 0.644722031408759 0.6447191663001368 3.406592747612347e-07 -0.06626586023576068 +0.525 0.6447385530005594 0.6447356806441311 3.239458936793449e-07 -0.06627437992422362 +0.5251 0.6447550706795573 0.6447521914034786 3.071635829715591e-07 -0.06628289789735801 +0.5252 0.6447715844456205 0.6447686985793719 2.903155631034382e-07 -0.06629141415528883 +0.5253000000000001 0.644788094298649 0.6447852021729719 2.73405067301169e-07 -0.0662999286981411 +0.5254 0.6448046002385746 0.6448017021854077 2.5643534096175813e-07 -0.06630844152603999 +0.5255 0.6448211022653607 0.6448181986177772 2.3940964108404295e-07 -0.06631695263911082 +0.5256000000000001 0.6448376003790028 0.6448346914711459 2.2233123557480194e-07 -0.06632546203747897 +0.5257000000000001 0.6448540945795291 0.6448511807465475 2.0520340266588777e-07 -0.06633396972126991 +0.5258 0.6448705848669991 0.6448676664449837 1.8802943024115448e-07 -0.06634247569060925 +0.5258999999999999 0.6448870712415055 0.6448841485674238 1.7081261529522385e-07 -0.06635097994562268 +0.526 0.6449035537031728 0.6449006271148051 1.5355626312857362e-07 -0.06635948248643604 +0.5261 0.6449200322521585 0.6449171020880327 1.362636869277345e-07 -0.06636798331317527 +0.5262 0.6449365068886526 0.6449335734879789 1.1893820694650059e-07 -0.0663764824259664 +0.5263000000000001 0.6449529776128773 0.6449500413154838 1.0158314999939022e-07 -0.06638497982493556 +0.5264 0.644969444425088 0.6449665055713547 8.42018487608176e-08 -0.06639347551020895 +0.5265 0.6449859073255727 0.6449829662563666 6.679764110242847e-08 -0.066401969481913 +0.5266000000000001 0.6450023663146525 0.6449994233712619 4.937386953104972e-08 -0.06641046174017413 +0.5267000000000001 0.6450188213926807 0.6450158769167501 3.1933880447962415e-08 -0.06641895228511893 +0.5268 0.6450352725600441 0.6450323268935079 1.4481023586851438e-08 -0.06642744111687404 +0.5268999999999999 0.6450517198171623 0.6450487733021792 -2.981348667940864e-09 -0.0664359282355663 +0.527 0.6450681631644877 0.6450652161433754 -2.0449881911986656e-08 -0.06644441364132253 +0.5271 0.6450846026025058 0.645081655417675 -3.7921220379967535e-08 -0.06645289733426978 +0.5272 0.6451010381317351 0.6450980911256239 -5.5392007580529114e-08 -0.06646137931453514 +0.5273000000000001 0.6451174697527271 0.6451145232677347 -7.285888694100184e-08 -0.06646985958224577 +0.5274 0.6451338974660662 0.6451309518444871 -9.031850245911494e-08 -0.06647833813752907 +0.5275 0.6451503212723702 0.6451473768563287 -1.0776749934278407e-07 -0.06648681498051243 +0.5276000000000001 0.645166741172289 0.6451637983036738 -1.2520252465515747e-07 -0.06649529011132335 +0.5277000000000001 0.6451831571665064 0.6451802161869038 -1.4262022797646712e-07 -0.0665037635300895 +0.5278 0.6451995692557387 0.6451966305063677 -1.6001726201378408e-07 -0.0665122352369386 +0.5278999999999999 0.6452159774407351 0.6452130412623817 -1.7739028329230577e-07 -0.0665207052319985 +0.528 0.6452323817222778 0.6452294484552291 -1.947359527312842e-07 -0.06652917351539721 +0.5281 0.6452487821011814 0.6452458520851605 -2.1205093637260974e-07 -0.06653764008726269 +0.5282 0.6452651785782937 0.6452622521523943 -2.2933190596541309e-07 -0.06654610494772319 +0.5283000000000001 0.6452815711544954 0.6452786486571164 -2.4657553961138223e-07 -0.06655456809690699 +0.5284 0.6452979598306992 0.6452950415994797 -2.6377852242048805e-07 -0.06656302953494242 +0.5285 0.6453143446078509 0.6453114309796049 -2.809375471493625e-07 -0.06657148926195798 +0.5286000000000001 0.6453307254869285 0.6453278167975803 -2.98049314825799e-07 -0.0665799472780823 +0.5287000000000001 0.6453471024689428 0.6453441990534626 -3.1511053536631417e-07 -0.06658840358344402 +0.5288 0.6453634755549363 0.6453605777472755 -3.321179283047315e-07 -0.06659685817817197 +0.5288999999999999 0.6453798447459844 0.6453769528790109 -3.490682232987208e-07 -0.06660531106239506 +0.529 0.6453962100431941 0.6453933244486291 -3.659581608098095e-07 -0.0666137622362423 +0.5291 0.6454125714477049 0.6454096924560581 -3.827844927348223e-07 -0.06662221169984284 +0.5292 0.6454289289606878 0.6454260569011943 -3.9954398309977046e-07 -0.06663065945332587 +0.5293000000000001 0.645445282583346 0.6454424177839025 -4.1623340854557433e-07 -0.06663910549682074 +0.5294 0.645461632316914 0.6454587751040161 -4.328495590774639e-07 -0.06664754983045688 +0.5295 0.6454779781626578 0.645475128861337 -4.493892386270293e-07 -0.06665599245436384 +0.5296000000000001 0.6454943201218752 0.6454914790556356 -4.6584926563508766e-07 -0.06666443336867124 +0.5297000000000001 0.6455106581958948 0.6455078256866521 -4.822264737108783e-07 -0.06667287257350885 +0.5298 0.6455269923860769 0.6455241687540946 -4.985177123190132e-07 -0.06668131006900653 +0.5298999999999999 0.6455433226938122 0.6455405082576414 -5.147198471888714e-07 -0.06668974585529429 +0.53 0.6455596491205223 0.6455568441969398 -5.308297610917556e-07 -0.06669817993250214 +0.5301 0.6455759716676597 0.6455731765716065 -5.468443543821255e-07 -0.06670661230076029 +0.5302 0.6455922903367067 0.6455895053812282 -5.627605456498541e-07 -0.06671504296019896 +0.5303000000000001 0.6456086051291767 0.6456058306253611 -5.785752721643167e-07 -0.06672347191094861 +0.5304 0.6456249160466125 0.6456221523035321 -5.942854906515471e-07 -0.06673189915313969 +0.5305 0.6456412230905872 0.6456384704152378 -6.098881778215937e-07 -0.06674032468690277 +0.5306000000000001 0.6456575262627036 0.6456547849599455 -6.253803307709749e-07 -0.0667487485123686 +0.5307000000000001 0.6456738255645937 0.6456710959370933 -6.407589679957582e-07 -0.06675717062966793 +0.5308 0.6456901209979191 0.6456874033460901 -6.560211294470708e-07 -0.06676559103893175 +0.5308999999999999 0.64570641256437 0.645703707186316 -6.711638774331563e-07 -0.06677400974029099 +0.531 0.6457227002656659 0.6457200074571219 -6.861842972161192e-07 -0.06678242673387676 +0.5311 0.6457389841035548 0.6457363041578311 -7.010794972894807e-07 -0.06679084201982036 +0.5312 0.6457552640798131 0.645752597287738 -7.158466102663574e-07 -0.06679925559825306 +0.5313000000000001 0.645771540196245 0.6457688868461092 -7.304827931847724e-07 -0.06680766746930629 +0.5314 0.6457878124546832 0.6457851728321838 -7.449852282293001e-07 -0.06681607763311158 +0.5315 0.6458040808569878 0.6458014552451731 -7.59351123105767e-07 -0.06682448608980061 +0.5316000000000001 0.6458203454050464 0.645817734084261 -7.735777118045295e-07 -0.0668328928395051 +0.5317000000000001 0.6458366061007734 0.6458340093486052 -7.876622549196632e-07 -0.06684129788235686 +0.5318 0.6458528629461104 0.6458502810373357 -8.01602040315097e-07 -0.0668497012184879 +0.5318999999999999 0.6458691159430259 0.6458665491495564 -8.153943836658462e-07 -0.06685810284803023 +0.532 0.645885365093514 0.6458828136843456 -8.290366287078133e-07 -0.06686650277111605 +0.5321 0.6459016103995956 0.6458990746407547 -8.425261482369883e-07 -0.06687490098787759 +0.5322 0.6459178518633168 0.6459153320178104 -8.558603441510826e-07 -0.06688329749844721 +0.5323000000000001 0.6459340894867494 0.6459315858145132 -8.69036648309951e-07 -0.06689169230295737 +0.5324 0.6459503232719909 0.6459478360298392 -8.820525227160037e-07 -0.06690008540154067 +0.5325 0.6459665532211631 0.6459640826627395 -8.949054601248285e-07 -0.0669084767943298 +0.5326000000000001 0.6459827793364126 0.645980325712141 -9.07592984850103e-07 -0.06691686648145752 +0.5327000000000001 0.6459990016199102 0.6459965651769461 -9.201126527080827e-07 -0.06692525446305671 +0.5328 0.6460152200738509 0.6460128010560338 -9.324620518502691e-07 -0.06693364073926035 +0.5328999999999999 0.6460314347004532 0.6460290333482589 -9.446388030687203e-07 -0.06694202531020155 +0.533 0.646047645501959 0.6460452620524537 -9.566405605176964e-07 -0.06695040817601348 +0.5331 0.6460638524806331 0.6460614871674277 -9.684650116026372e-07 -0.06695878933682947 +0.5332 0.6460800556387633 0.6460777086919673 -9.80109878090385e-07 -0.06696716879278289 +0.5333000000000001 0.6460962549786593 0.6460939266248373 -9.915729162479625e-07 -0.06697554654400727 +0.5334 0.6461124505026534 0.6461101409647803 -1.0028519171478845e-06 -0.06698392259063621 +0.5335 0.6461286422130987 0.646126351710517 -1.013944707334291e-06 -0.06699229693280338 +0.5336000000000001 0.6461448301123706 0.6461425588607481 -1.024849149044993e-06 -0.06700066957064264 +0.5337000000000001 0.6461610142028645 0.6461587624141524 -1.0355631409331156e-06 -0.06700904050428784 +0.5338 0.6461771944869974 0.6461749623693888 -1.0460846181781225e-06 -0.06701740973387309 +0.5338999999999999 0.6461933709672057 0.646191158725096 -1.0564115530964369e-06 -0.06702577725953245 +0.534 0.6462095436459464 0.6462073514798929 -1.0665419550859312e-06 -0.06703414308140017 +0.5341 0.6462257125256953 0.6462235406323793 -1.0764738716806388e-06 -0.06704250719961055 +0.5342 0.6462418776089477 0.6462397261811357 -1.086205388411976e-06 -0.06705086961429803 +0.5343000000000001 0.6462580388982178 0.6462559081247241 -1.095734629474876e-06 -0.06705923032559712 +0.5344 0.6462741963960379 0.6462720864616883 -1.1050597581163668e-06 -0.06706758933364247 +0.5345 0.6462903501049586 0.6462882611905543 -1.1141789766910826e-06 -0.06707594663856883 +0.5346000000000001 0.6463065000275479 0.6463044323098305 -1.1230905271886193e-06 -0.067084302240511 +0.5347000000000001 0.6463226461663911 0.6463205998180085 -1.1317926916776244e-06 -0.06709265613960397 +0.5348 0.6463387885240903 0.6463367637135629 -1.1402837924445741e-06 -0.06710100833598275 +0.5348999999999999 0.646354927103264 0.6463529239949524 -1.148562192576641e-06 -0.06710935882978246 +0.535 0.6463710619065469 0.6463690806606195 -1.1566262960172047e-06 -0.06711770762113836 +0.5351 0.6463871929365893 0.6463852337089911 -1.164474547926675e-06 -0.06712605471018585 +0.5352 0.6464033201960564 0.6464013831384798 -1.1721054351265803e-06 -0.06713440009706033 +0.5353000000000001 0.6464194436876289 0.6464175289474827 -1.1795174864326352e-06 -0.0671427437818974 +0.5354 0.6464355634140011 0.646433671134383 -1.186709272599229e-06 -0.06715108576483264 +0.5355 0.6464516793778817 0.64644980969755 -1.193679407013315e-06 -0.06715942604600185 +0.5356000000000001 0.646467791581993 0.6464659446353396 -1.2004265456666552e-06 -0.06716776462554087 +0.5357000000000001 0.6464839000290705 0.6464820759460947 -1.2069493875721538e-06 -0.06717610150358568 +0.5358 0.6465000047218622 0.6464982036281459 -1.213246674958146e-06 -0.0671844366802723 +0.5358999999999999 0.6465161056631286 0.6465143276798113 -1.2193171936014657e-06 -0.06719277015573694 +0.536 0.6465322028556417 0.6465304480993974 -1.2251597728274444e-06 -0.06720110193011584 +0.5361 0.6465482963021856 0.6465465648851992 -1.2307732862315568e-06 -0.06720943200354534 +0.5362 0.6465643860055549 0.6465626780355015 -1.2361566512630873e-06 -0.06721776037616195 +0.5363000000000001 0.6465804719685551 0.6465787875485778 -1.2413088300300412e-06 -0.06722608704810222 +0.5364 0.6465965541940015 0.6465948934226924 -1.2462288290215895e-06 -0.06723441201950282 +0.5365 0.6466126326847191 0.6466109956560994 -1.250915699524402e-06 -0.0672427352905005 +0.5366000000000001 0.6466287074435428 0.6466270942470445 -1.25536853798347e-06 -0.06725105686123216 +0.5367000000000001 0.6466447784733156 0.6466431891937638 -1.2595864858633288e-06 -0.06725937673183474 +0.5368 0.6466608457768892 0.6466592804944862 -1.263568730036635e-06 -0.06726769490244534 +0.5368999999999999 0.646676909357123 0.6466753681474322 -1.2673145026731447e-06 -0.06727601137320115 +0.537 0.6466929692168841 0.6466914521508152 -1.2708230818503363e-06 -0.06728432614423936 +0.5371 0.6467090253590468 0.6467075325028417 -1.2740937913036099e-06 -0.06729263921569748 +0.5372 0.6467250777864915 0.6467236092017115 -1.2771260006205765e-06 -0.06730095058771284 +0.5373000000000001 0.646741126502105 0.6467396822456186 -1.2799191254631026e-06 -0.06730926026042308 +0.5374 0.64675717150878 0.6467557516327519 -1.282472627789355e-06 -0.0673175682339659 +0.5375 0.6467732128094139 0.6467718173612945 -1.2847860156317559e-06 -0.06732587450847904 +0.5376000000000001 0.6467892504069093 0.6467878794294253 -1.2868588436520945e-06 -0.06733417908410037 +0.5377000000000001 0.646805284304173 0.6468039378353192 -1.2886907126419267e-06 -0.06734248196096793 +0.5378000000000001 0.6468213145041155 0.6468199925771472 -1.2902812702442201e-06 -0.06735078313921976 +0.5378999999999999 0.646837341009651 0.6468360436530769 -1.2916302105925315e-06 -0.06735908261899404 +0.538 0.6468533638236961 0.6468520910612733 -1.2927372745052956e-06 -0.06736738040042903 +0.5381 0.6468693829491705 0.646868134799899 -1.2936022494858257e-06 -0.0673756764836631 +0.5382 0.6468853983889955 0.646884174867115 -1.294224969722313e-06 -0.06738397086883478 +0.5383000000000001 0.6469014101460943 0.6469002112610807 -1.2946053165041604e-06 -0.06739226355608263 +0.5384 0.646917418223391 0.6469162439799542 -1.2947432176668716e-06 -0.06740055454554533 +0.5385 0.6469334226238102 0.6469322730218936 -1.2946386482026728e-06 -0.06740884383736165 +0.5386 0.6469494233502766 0.6469482983850571 -1.2942916296776463e-06 -0.06741713143167048 +0.5387000000000001 0.6469654204057151 0.6469643200676027 -1.2937022308701085e-06 -0.06742541732861078 +0.5388000000000001 0.6469814137930496 0.64698033806769 -1.2928705671322316e-06 -0.06743370152832161 +0.5388999999999999 0.6469974035152027 0.6469963523834794 -1.2917968006675995e-06 -0.06744198403094219 +0.539 0.6470133895750954 0.6470123630131334 -1.2904811406144745e-06 -0.06745026483661179 +0.5391 0.6470293719756466 0.6470283699548167 -1.2889238428792638e-06 -0.06745854394546977 +0.5392 0.6470453507197724 0.6470443732066968 -1.2871252101365194e-06 -0.06746682135765561 +0.5393000000000001 0.6470613258103864 0.6470603727669446 -1.2850855914958714e-06 -0.06747509707330888 +0.5394 0.6470772972503982 0.6470763686337342 -1.2828053830571395e-06 -0.0674833710925693 +0.5395 0.6470932650427133 0.6470923608052441 -1.2802850272719546e-06 -0.06749164341557659 +0.5396 0.6471092291902332 0.6471083492796574 -1.2775250129715143e-06 -0.06749991404247069 +0.5397000000000001 0.6471251896958543 0.6471243340551622 -1.2745258755331168e-06 -0.0675081829733915 +0.5398000000000001 0.6471411465624679 0.6471403151299518 -1.2712881964915823e-06 -0.06751645020847913 +0.5398999999999999 0.6471570997929592 0.6471562925022261 -1.2678126036225201e-06 -0.06752471574787373 +0.54 0.6471730493902074 0.6471722661701905 -1.2640997706370172e-06 -0.06753297959171559 +0.5401 0.6471889953570847 0.6471882361320582 -1.2601504174036826e-06 -0.06754124174014511 +0.5402 0.6472049376964566 0.6472042023860489 -1.2559653093657808e-06 -0.0675495021933027 +0.5403000000000001 0.6472208764111804 0.6472201649303906 -1.2515452576244979e-06 -0.06755776095132894 +0.5404 0.6472368115041056 0.6472361237633192 -1.2468911188001641e-06 -0.0675660180143645 +0.5405 0.6472527429780738 0.6472520788830793 -1.2420037948102092e-06 -0.06757427338255016 +0.5406 0.6472686708359167 0.647268030287925 -1.2368842328969176e-06 -0.06758252705602678 +0.5407000000000001 0.647284595080457 0.6472839779761193 -1.2315334252110954e-06 -0.06759077903493531 +0.5408000000000001 0.6473005157145078 0.6472999219459351 -1.2259524085900253e-06 -0.06759902931941678 +0.5408999999999999 0.6473164327408716 0.6473158621956567 -1.2201422645019555e-06 -0.06760727790961239 +0.541 0.6473323461623406 0.6473317987235783 -1.2141041188240553e-06 -0.0676155248056634 +0.5411 0.6473482559816953 0.6473477315280057 -1.2078391416758816e-06 -0.06762377000771116 +0.5412 0.6473641622017052 0.6473636606072566 -1.2013485470308005e-06 -0.0676320135158971 +0.5413000000000001 0.6473800648251273 0.6473795859596605 -1.1946335925216989e-06 -0.0676402553303628 +0.5414 0.6473959638547063 0.64739550758356 -1.1876955794687394e-06 -0.06764849545124989 +0.5415 0.6474118592931742 0.6474114254773103 -1.1805358522409826e-06 -0.06765673387870012 +0.5416 0.6474277511432496 0.6474273396392802 -1.173155798367409e-06 -0.06766497061285537 +0.5417000000000001 0.6474436394076372 0.6474432500678525 -1.1655568479262968e-06 -0.06767320565385758 +0.5418000000000001 0.647459524089028 0.6474591567614237 -1.1577404735729768e-06 -0.06768143900184874 +0.5418999999999999 0.6474754051900977 0.6474750597184058 -1.1497081900124773e-06 -0.06768967065697101 +0.542 0.6474912827135083 0.6474909589372252 -1.1414615538052342e-06 -0.06769790061936667 +0.5421 0.6475071566619051 0.6475068544163244 -1.1330021632283138e-06 -0.06770612888917803 +0.5422 0.6475230270379179 0.6475227461541614 -1.1243316576370344e-06 -0.06771435546654746 +0.5423000000000001 0.6475388938441611 0.6475386341492111 -1.1154517174094547e-06 -0.06772258035161761 +0.5424 0.6475547570832314 0.6475545183999643 -1.1063640636133076e-06 -0.06773080354453101 +0.5425 0.6475706167577095 0.6475703989049297 -1.097070457534155e-06 -0.06773902504543043 +0.5426 0.6475864728701581 0.6475862756626336 -1.0875727004810987e-06 -0.06774724485445871 +0.5427000000000001 0.6476023254231223 0.6476021486716192 -1.077872633370447e-06 -0.06775546297175872 +0.5428000000000001 0.6476181744191291 0.6476180179304492 -1.0679721362816252e-06 -0.06776367939747352 +0.5428999999999999 0.6476340198606862 0.6476338834377043 -1.0578731284294207e-06 -0.06777189413174615 +0.543 0.6476498617502837 0.6476497451919848 -1.0475775671647813e-06 -0.06778010717471995 +0.5431 0.6476657000903914 0.6476656031919099 -1.0370874484744164e-06 -0.06778831852653812 +0.5432 0.6476815348834596 0.647681457436119 -1.0264048058428177e-06 -0.06779652818734412 +0.5433000000000001 0.6476973661319186 0.6476973079232716 -1.0155317100579708e-06 -0.06780473615728143 +0.5434 0.6477131938381784 0.6477131546520479 -1.004470269017066e-06 -0.06781294243649362 +0.5435 0.647729018004628 0.6477289976211489 -9.932226272824085e-07 -0.06782114702512447 +0.5436 0.6477448386336355 0.6477448368292972 -9.817909654707968e-07 -0.06782934992331775 +0.5437000000000001 0.6477606557275468 0.6477606722752365 -9.701775000314772e-07 -0.06783755113121732 +0.5438000000000001 0.6477764692886869 0.647776503957733 -9.583844825244991e-07 -0.06784575064896718 +0.5438999999999999 0.6477922793193578 0.6477923318755752 -9.464141996762265e-07 -0.06785394847671143 +0.544 0.6478080858218391 0.6478081560275738 -9.342689724356479e-07 -0.06786214461459421 +0.5441 0.6478238887983881 0.6478239764125633 -9.219511559188653e-07 -0.06787033906275981 +0.5442 0.6478396882512384 0.647839793029401 -9.094631385764274e-07 -0.06787853182135266 +0.5443000000000001 0.6478554841825998 0.6478556058769681 -8.968073422488398e-07 -0.06788672289051716 +0.5444 0.6478712765946585 0.64787141495417 -8.839862210840987e-07 -0.0678949122703979 +0.5445 0.6478870654895766 0.6478872202599361 -8.710022616209567e-07 -0.06790309996113955 +0.5446 0.6479028508694915 0.6479030217932207 -8.578579819285004e-07 -0.06791128596288686 +0.5447000000000001 0.647918632736516 0.6479188195530028 -8.445559313008388e-07 -0.0679194702757847 +0.5448000000000001 0.6479344110927374 0.6479346135382873 -8.3109868959097e-07 -0.067927652899978 +0.5448999999999999 0.6479501859402178 0.6479504037481039 -8.174888670720026e-07 -0.06793583383561183 +0.545 0.6479659572809937 0.6479661901815087 -8.037291035073446e-07 -0.06794401308283134 +0.5451 0.6479817251170753 0.6479819728375835 -7.898220680396806e-07 -0.0679521906417817 +0.5452 0.6479974894504467 0.6479977517154372 -7.757704582334046e-07 -0.06796036651260834 +0.5453000000000001 0.648013250283065 0.6480135268142048 -7.615769999774757e-07 -0.06796854069545664 +0.5454 0.6480290076168612 0.6480292981330488 -7.472444467082617e-07 -0.06797671319047215 +0.5455 0.6480447614537382 0.6480450656711585 -7.327755789099388e-07 -0.06798488399780045 +0.5456 0.6480605117955722 0.6480608294277513 -7.181732036842803e-07 -0.06799305311758728 +0.5457000000000001 0.6480762586442118 0.648076589402072 -7.034401540845225e-07 -0.06800122054997848 +0.5458000000000001 0.6480920020014769 0.6480923455933936 -6.885792886157649e-07 -0.06800938629511992 +0.5458999999999999 0.6481077418691601 0.6481080980010174 -6.735934907492469e-07 -0.06801755035315764 +0.546 0.648123478249025 0.6481238466242732 -6.584856682423368e-07 -0.06802571272423773 +0.5461 0.6481392111428068 0.6481395914625196 -6.432587526528089e-07 -0.06803387340850635 +0.5462 0.648154940552212 0.6481553325151445 -6.279156987420986e-07 -0.06804203240610984 +0.5463000000000001 0.6481706664789175 0.6481710697815646 -6.12459483878558e-07 -0.06805018971719456 +0.5464 0.6481863889245714 0.648186803261226 -5.968931075794881e-07 -0.06805834534190698 +0.5465 0.6482021078907914 0.6482025329536052 -5.812195908172502e-07 -0.06806649928039368 +0.5466 0.6482178233791668 0.6482182588582083 -5.654419754225204e-07 -0.06807465153280139 +0.5467000000000001 0.6482335353912556 0.6482339809745711 -5.495633236124453e-07 -0.06808280209927682 +0.5468000000000001 0.6482492439285863 0.6482496993022598 -5.335867172828745e-07 -0.0680909509799668 +0.5468999999999999 0.6482649489926567 0.6482654138408717 -5.175152574948827e-07 -0.06809909817501832 +0.547 0.6482806505849344 0.6482811245900342 -5.013520637392466e-07 -0.0681072436845784 +0.5471 0.6482963487068565 0.648296831549406 -4.851002735062337e-07 -0.06811538750879428 +0.5472 0.6483120433598283 0.6483125347186762 -4.6876304155007986e-07 -0.06812352964781314 +0.5473000000000001 0.6483277345452249 0.6483282340975657 -4.523435394171438e-07 -0.06813167010178228 +0.5474 0.6483434222643896 0.6483439296858267 -4.3584495461324035e-07 -0.06813980887084917 +0.5475 0.6483591065186347 0.6483596214832423 -4.192704901873068e-07 -0.06814794595516133 +0.5476 0.6483747873092407 0.6483753094896284 -4.0262336398894094e-07 -0.06815608135486638 +0.5477000000000001 0.6483904646374564 0.6483909937048316 -3.859068081410455e-07 -0.06816421507011199 +0.5478000000000001 0.6484061385044991 0.6484066741287313 -3.6912406834593847e-07 -0.06817234710104601 +0.5478999999999999 0.6484218089115538 0.6484223507612386 -3.5227840329554727e-07 -0.06818047744781636 +0.548 0.6484374758597733 0.6484380236022971 -3.353730839567026e-07 -0.068188606110571 +0.5481 0.6484531393502784 0.648453692651882 -3.1841139302296595e-07 -0.06819673308945799 +0.5482 0.6484687993841579 0.648469357910002 -3.0139662428319003e-07 -0.06820485838462557 +0.5483000000000001 0.6484844559624678 0.6484850193766977 -2.843320819068129e-07 -0.06821298199622203 +0.5484 0.6485001090862313 0.6485006770520425 -2.672210798401742e-07 -0.06822110392439566 +0.5485 0.6485157587564396 0.6485163309361428 -2.500669412167089e-07 -0.068229224169295 +0.5486 0.6485314049740507 0.6485319810291373 -2.32872997621425e-07 -0.06823734273106857 +0.5487000000000001 0.6485470477399898 0.6485476273311982 -2.156425885323221e-07 -0.06824545960986504 +0.5488000000000001 0.6485626870551497 0.6485632698425305 -1.9837906057446064e-07 -0.06825357480583316 +0.5488999999999999 0.64857832292039 0.6485789085633722 -1.8108576695791134e-07 -0.06826168831912176 +0.549 0.648593955336537 0.6485945434939945 -1.6376606676304917e-07 -0.06826980014987975 +0.5491 0.6486095843043842 0.6486101746347018 -1.4642332433686955e-07 -0.06827791029825618 +0.5492 0.6486252098246919 0.6486258019858318 -1.2906090861644626e-07 -0.06828601876440016 +0.5493000000000001 0.6486408318981877 0.6486414255477553 -1.116821924680017e-07 -0.06829412554846094 +0.5494 0.6486564505255653 0.6486570453208768 -9.42905520589371e-08 -0.06830223065058778 +0.5495 0.6486720657074854 0.6486726613056338 -7.688936615179998e-08 -0.06831033407093011 +0.5496 0.6486876774445758 0.6486882735024974 -5.948201549886567e-08 -0.06831843580963744 +0.5497000000000001 0.6487032857374304 0.6487038819119718 -4.2071882157788953e-08 -0.06832653586685929 +0.5498000000000001 0.6487188905866105 0.6487194865345951 -2.4662348845636353e-08 -0.06833463424274538 +0.5498999999999999 0.6487344919926438 0.6487350873709387 -7.256798272535503e-09 -0.06834273093744553 +0.55 0.6487500899560243 0.6487506844216067 1.0141387514484013e-08 -0.0683508259511095 +0.5501 0.6487656844772134 0.6487662776872375 2.7528827783313004e-08 -0.0683589192838873 +0.5502 0.6487812755566392 0.6487818671685027 4.490214378441437e-08 -0.06836701093592905 +0.5503000000000001 0.6487968631946961 0.6487974528661069 6.225795939895917e-08 -0.06837510090738479 +0.5504 0.6488124473917454 0.6488130347807886 7.959290179715417e-08 -0.06838318919840482 +0.5505 0.6488280281481156 0.648828612913319 9.690360209743676e-08 -0.06839127580913945 +0.5506 0.6488436054641016 0.6488441872645029 1.1418669602913933e-07 -0.0683993607397391 +0.5507000000000001 0.6488591793399653 0.6488597578351785 1.3143882456739808e-07 -0.06840744399035428 +0.5508000000000001 0.648874749775936 0.6488753246262167 1.4865663460969514e-07 -0.06841552556113562 +0.5509 0.6488903167722095 0.6488908876385219 1.6583677960035903e-07 -0.0684236054522338 +0.551 0.6489058803289491 0.6489064468730316 1.8297592021404574e-07 -0.06843168366379966 +0.5511 0.6489214404462845 0.6489220023307156 2.0007072501493361e-07 -0.06843976019598401 +0.5512 0.6489369971243136 0.6489375540125777 2.17117871036121e-07 -0.06844783504893787 +0.5513000000000001 0.6489525503631008 0.6489531019196533 2.3411404450474071e-07 -0.06845590822281228 +0.5514 0.6489681001626787 0.6489686460530114 2.510559414387048e-07 -0.0684639797177584 +0.5515 0.6489836465230467 0.6489841864137533 2.6794026831977735e-07 -0.06847204953392753 +0.5516 0.6489991894441725 0.6489997230030129 2.847637427250138e-07 -0.06848011767147098 +0.5517000000000001 0.6490147289259909 0.6490152558219563 3.015230939720781e-07 -0.06848818413054021 +0.5518000000000001 0.6490302649684047 0.6490307848717818 3.182150637298653e-07 -0.0684962489112867 +0.5519 0.649045797571285 0.6490463101537205 3.3483640666381875e-07 -0.06850431201386213 +0.552 0.6490613267344707 0.6490618316690351 3.513838911367584e-07 -0.06851237343841819 +0.5521 0.649076852457769 0.6490773494190198 3.6785429972929773e-07 -0.06852043318510669 +0.5522 0.6490923747409556 0.6490928634050013 3.8424442991291663e-07 -0.06852849125407953 +0.5523 0.6491078935837744 0.6491083736283374 4.005510947091562e-07 -0.06853654764548865 +0.5524 0.6491234089859383 0.6491238800904173 4.167711232655469e-07 -0.06854460235948621 +0.5525 0.6491389209471288 0.649139382792662 4.329013615356203e-07 -0.06855265539622434 +0.5526 0.6491544294669968 0.6491548817365232 4.4893867275075383e-07 -0.06856070675585527 +0.5527000000000001 0.649169934545162 0.6491703769234836 4.648799382667157e-07 -0.06856875643853137 +0.5528000000000001 0.6491854361812135 0.6491858683550568 4.807220579244875e-07 -0.06857680444440514 +0.5529 0.6492009343747102 0.649201356032787 4.964619508274204e-07 -0.0685848507736291 +0.553 0.6492164291251803 0.6492168399582482 5.120965558685908e-07 -0.0685928954263558 +0.5531 0.6492319204321222 0.6492323201330457 5.276228323553012e-07 -0.06860093840273802 +0.5532 0.6492474082950046 0.6492477965588137 5.430377605503134e-07 -0.06860897970292859 +0.5533 0.6492628927132665 0.6492632692372169 5.583383423241051e-07 -0.06861701932708038 +0.5534 0.649278373686317 0.6492787381699493 5.735216017238587e-07 -0.06862505727534636 +0.5535 0.6492938512135364 0.6492942033587343 5.885845856118399e-07 -0.06863309354787965 +0.5536 0.6493093252942759 0.6493096648053243 6.035243640817312e-07 -0.0686411281448334 +0.5537000000000001 0.649324795927858 0.6493251225115008 6.183380311941544e-07 -0.06864916106636092 +0.5538000000000001 0.6493402631135765 0.6493405764790737 6.330227054068827e-07 -0.0686571923126155 +0.5539 0.6493557268506971 0.6493560267098815 6.475755303519959e-07 -0.06866522188375061 +0.554 0.6493711871384574 0.6493714732057906 6.619936750856814e-07 -0.06867324977991977 +0.5541 0.6493866439760672 0.6493869159686959 6.762743348931455e-07 -0.06868127600127664 +0.5542 0.6494020973627086 0.6494023550005195 6.904147317882137e-07 -0.06868930054797492 +0.5543 0.6494175472975369 0.649417790303211 7.044121150129312e-07 -0.06869732342016847 +0.5544 0.6494329937796799 0.6494332218787471 7.182637615371634e-07 -0.06870534461801113 +0.5545 0.6494484368082389 0.6494486497291309 7.319669766275849e-07 -0.06871336414165687 +0.5546 0.649463876382289 0.6494640738563927 7.455190943750356e-07 -0.0687213819912598 +0.5547000000000001 0.6494793125008789 0.6494794942625889 7.589174783884101e-07 -0.0687293981669741 +0.5548000000000001 0.6494947451630312 0.6494949109498016 7.721595220444577e-07 -0.06873741266895399 +0.5549 0.6495101743677438 0.6495103239201391 7.852426489873832e-07 -0.0687454254973539 +0.555 0.649525600113988 0.6495257331757345 7.981643138921246e-07 -0.06875343665232815 +0.5551 0.6495410224007114 0.6495411387187462 8.109220028529318e-07 -0.06876144613403133 +0.5552 0.6495564412268364 0.6495565405513575 8.235132338274553e-07 -0.06876945394261808 +0.5553 0.649571856591261 0.6495719386757762 8.359355570808358e-07 -0.06877746007824306 +0.5554 0.6495872684928596 0.6495873330942341 8.481865556575485e-07 -0.06878546454106112 +0.5555 0.6496026769304825 0.6496027238089865 8.602638461030487e-07 -0.06879346733122711 +0.5556 0.6496180819029568 0.6496181108223128 8.721650785747936e-07 -0.06880146844889606 +0.5557000000000001 0.6496334834090866 0.649633494136515 8.838879375361319e-07 -0.06880946789422299 +0.5558000000000001 0.6496488814476531 0.6496488737539181 8.954301423391708e-07 -0.06881746566736303 +0.5559 0.6496642760174157 0.6496642496768694 9.067894472525317e-07 -0.06882546176847147 +0.556 0.6496796671171116 0.6496796219077386 9.179636421274839e-07 -0.06883345619770363 +0.5561 0.6496950547454556 0.649694990448917 9.289505531195896e-07 -0.06884144895521492 +0.5562 0.6497104389011428 0.6497103553028174 9.397480424111482e-07 -0.06884944004116093 +0.5563 0.649725819582846 0.6497257164718733 9.503540093769303e-07 -0.0688574294556972 +0.5564 0.6497411967892179 0.6497410739585392 9.607663905564223e-07 -0.0688654171989794 +0.5565 0.6497565705188911 0.6497564277652899 9.709831602922048e-07 -0.06887340327116337 +0.5566 0.6497719407704787 0.6497717778946196 9.810023307854632e-07 -0.06888138767240495 +0.5567000000000001 0.6497873075425734 0.6497871243490431 9.90821953095189e-07 -0.06888937040286011 +0.5568000000000001 0.6498026708337499 0.6498024671310932 1.0004401166108234e-06 -0.06889735146268487 +0.5569 0.6498180306425638 0.6498178062433223 1.00985495035677e-06 -0.06890533085203542 +0.557 0.6498333869675521 0.6498331416883009 1.0190646229091271e-06 -0.06891330857106794 +0.5571 0.6498487398072347 0.6498484734686174 1.0280673427287557e-06 -0.06892128461993875 +0.5572 0.6498640891601133 0.6498638015868781 1.0368613586331232e-06 -0.0689292589988043 +0.5573 0.6498794350246727 0.649879126045706 1.0454449601016158e-06 -0.068937231707821 +0.5574 0.6498947773993813 0.6498944468477414 1.053816477580849e-06 -0.06894520274714551 +0.5575 0.649910116282691 0.6499097639956408 1.0619742827899792e-06 -0.06895317211693446 +0.5576 0.6499254516730377 0.6499250774920766 1.0699167891925487e-06 -0.06896113981734457 +0.5577000000000001 0.6499407835688422 0.6499403873397374 1.0776424521907746e-06 -0.06896910584853282 +0.5578000000000001 0.64995611196851 0.6499556935413259 1.0851497695418821e-06 -0.06897707021065602 +0.5579 0.6499714368704319 0.6499709960995602 1.0924372814136163e-06 -0.06898503290387124 +0.558 0.6499867582729846 0.6499862950171726 1.0995035709115974e-06 -0.06899299392833555 +0.5581 0.6500020761745311 0.6500015902969097 1.1063472641348326e-06 -0.06900095328420622 +0.5582 0.650017390573421 0.6500168819415308 1.1129670308140938e-06 -0.0690089109716405 +0.5583 0.6500327014679907 0.6500321699538084 1.1193615841176285e-06 -0.06901686699079573 +0.5584 0.650048008856565 0.6500474543365284 1.125529681400561e-06 -0.06902482134182945 +0.5585 0.6500633127374551 0.6500627350924879 1.1314701238440694e-06 -0.06903277402489914 +0.5586 0.6500786131089623 0.6500780122244963 1.1371817572602971e-06 -0.0690407250401625 +0.5587000000000001 0.6500939099693757 0.6500932857353743 1.1426634719535755e-06 -0.06904867438777722 +0.5588000000000001 0.6501092033169735 0.6501085556279527 1.1479142034420686e-06 -0.06905662206790111 +0.5589 0.6501244931500243 0.650123821905074 1.1529329317916392e-06 -0.0690645680806921 +0.559 0.6501397794667865 0.6501390845695894 1.1577186826150498e-06 -0.06907251242630814 +0.5591 0.6501550622655087 0.6501543436243604 1.1622705267944067e-06 -0.06908045510490733 +0.5592 0.6501703415444318 0.6501695990722576 1.166587581258316e-06 -0.06908839611664787 +0.5593 0.6501856173017866 0.6501848509161599 1.170669008260239e-06 -0.06909633546168799 +0.5594 0.6502008895357968 0.650200099158954 1.174514016460959e-06 -0.06910427314018597 +0.5595 0.6502161582446786 0.6502153438035351 1.1781218602346932e-06 -0.06911220915230032 +0.5596 0.6502314234266404 0.6502305848528052 1.181491840585025e-06 -0.0691201434981895 +0.5597000000000001 0.6502466850798847 0.650245822309673 1.1846233049228605e-06 -0.06912807617801214 +0.5598000000000001 0.6502619432026071 0.6502610561770539 1.1875156470941839e-06 -0.06913600719192692 +0.5599 0.650277197792998 0.6502762864578691 1.1901683076298575e-06 -0.06914393654009264 +0.56 0.6502924488492419 0.6502915131550449 1.1925807739121552e-06 -0.0691518642226681 +0.5601 0.6503076963695191 0.6503067362715127 1.1947525801470071e-06 -0.06915979023981232 +0.5602 0.6503229403520052 0.6503219558102089 1.196683307835844e-06 -0.06916771459168435 +0.5603 0.650338180794872 0.6503371717740731 1.1983725851372196e-06 -0.06917563727844328 +0.5604 0.6503534176962874 0.6503523841660486 1.1998200875051879e-06 -0.06918355830024829 +0.5605 0.650368651054417 0.6503675929890821 1.201025537772571e-06 -0.06919147765725873 +0.5606 0.6503838808674235 0.650382798246123 1.2019887058734025e-06 -0.06919939534963393 +0.5607000000000001 0.6503991071334676 0.6503979999401224 1.2027094092037505e-06 -0.0692073113775334 +0.5608000000000001 0.6504143298507087 0.6504131980740335 1.2031875124829394e-06 -0.06921522574111669 +0.5609 0.6504295490173049 0.6504283926508106 1.2034229277535502e-06 -0.06922313844054344 +0.561 0.6504447646314134 0.6504435836734086 1.2034156144646868e-06 -0.06923104947597339 +0.5611 0.6504599766911918 0.6504587711447827 1.20316557963851e-06 -0.06923895884756633 +0.5612 0.6504751851947974 0.6504739550678882 1.2026728776759477e-06 -0.0692468665554822 +0.5613 0.6504903901403887 0.6504891354456797 1.2019376102456736e-06 -0.06925477259988101 +0.5614 0.6505055915261253 0.6505043122811097 1.2009599265339066e-06 -0.06926267698092274 +0.5615 0.6505207893501685 0.6505194855771308 1.1997400232166555e-06 -0.06927057969876764 +0.5616 0.6505359836106817 0.6505346553366922 1.1982781443486967e-06 -0.06927848075357593 +0.5617000000000001 0.6505511743058314 0.6505498215627412 1.1965745809472406e-06 -0.06928638014550799 +0.5618000000000001 0.6505663614337863 0.6505649842582215 1.1946296714915317e-06 -0.06929427787472416 +0.5619 0.6505815449927195 0.6505801434260741 1.1924438018395822e-06 -0.06930217394138492 +0.562 0.6505967249808078 0.6505952990692354 1.1900174044787715e-06 -0.06931006834565097 +0.5621 0.6506119013962328 0.6506104511906379 1.1873509594140241e-06 -0.06931796108768291 +0.5622 0.6506270742371807 0.6506255997932089 1.1844449931963652e-06 -0.06932585216764156 +0.5623 0.6506422435018433 0.6506407448798707 1.1813000796168094e-06 -0.06933374158568775 +0.5624 0.6506574091884185 0.6506558864535394 1.1779168389569605e-06 -0.06934162934198239 +0.5625 0.6506725712951101 0.650671024517125 1.1742959379890117e-06 -0.0693495154366865 +0.5626 0.6506877298201291 0.6506861590735309 1.1704380902810563e-06 -0.06935739986996121 +0.5627000000000001 0.6507028847616938 0.650701290125653 1.1663440554476878e-06 -0.06936528264196769 +0.5628000000000001 0.65071803611803 0.6507164176763802 1.1620146396218445e-06 -0.06937316375286724 +0.5629 0.6507331838873719 0.6507315417285928 1.1574506947331642e-06 -0.06938104320282122 +0.563 0.6507483280679625 0.6507466622851628 1.1526531185912514e-06 -0.06938892099199111 +0.5631 0.650763468658053 0.6507617793489527 1.1476228550522105e-06 -0.06939679712053835 +0.5632 0.6507786056559056 0.6507768929228164 1.142360893019445e-06 -0.06940467158862466 +0.5633 0.6507937390597914 0.6507920030095967 1.1368682671097918e-06 -0.06941254439641165 +0.5634 0.6508088688679925 0.6508071096121271 1.131146056959631e-06 -0.06942041554406113 +0.5635 0.6508239950788017 0.6508222127332302 1.1251953870305975e-06 -0.06942828503173504 +0.5636 0.650839117690523 0.6508373123757167 1.1190174267206032e-06 -0.06943615285959528 +0.5637000000000001 0.6508542367014727 0.6508524085423865 1.112613389697703e-06 -0.06944401902780391 +0.5638000000000001 0.650869352109979 0.6508675012360265 1.1059845340666286e-06 -0.06945188353652307 +0.5639 0.6508844639143823 0.6508825904594118 1.0991321618414318e-06 -0.06945974638591493 +0.564 0.6508995721130371 0.6508976762153036 1.0920576188622189e-06 -0.06946760757614179 +0.5641 0.6509146767043106 0.6509127585064509 1.084762294378816e-06 -0.0694754671073661 +0.5642 0.6509297776865842 0.6509278373355878 1.0772476208842363e-06 -0.06948332497975025 +0.5643 0.650944875058254 0.6509429127054347 1.0695150739759018e-06 -0.06949118119345687 +0.5644 0.6509599688177304 0.6509579846186968 1.0615661717172653e-06 -0.0694990357486485 +0.5645 0.6509750589634394 0.6509730530780646 1.0534024746933213e-06 -0.06950688864548792 +0.5646 0.6509901454938227 0.6509881180862128 1.045025585372228e-06 -0.06951473988413787 +0.5647000000000001 0.651005228407338 0.6510031796458007 1.0364371482718404e-06 -0.06952258946476135 +0.5648000000000001 0.651020307702459 0.6510182377594701 1.0276388492103106e-06 -0.06953043738752124 +0.5649 0.651035383377677 0.6510332924298471 1.0186324150285309e-06 -0.06953828365258063 +0.565 0.6510504554315002 0.65104834365954 1.0094196132570676e-06 -0.06954612826010269 +0.5651 0.6510655238624548 0.6510633914511399 1.0000022521994278e-06 -0.06955397121025059 +0.5652 0.6510805886690847 0.6510784358072194 9.903821800716361e-07 -0.06956181250318766 +0.5653 0.6510956498499525 0.6510934767303331 9.805612847801903e-07 -0.06956965213907729 +0.5654 0.6511107074036397 0.651108514223017 9.705414935057277e-07 -0.069577490118083 +0.5655 0.6511257613287471 0.6511235482877872 9.60324772647514e-07 -0.06958532644036826 +0.5656 0.651140811623895 0.6511385789271409 9.499131270462868e-07 -0.06959316110609678 +0.5657000000000001 0.6511558582877239 0.651153606143555 9.393085997067008e-07 -0.06960099411543226 +0.5658000000000001 0.6511709013188948 0.6511686299394867 9.285132714920152e-07 -0.06960882546853853 +0.5659 0.6511859407160893 0.6511836503173717 9.175292607077612e-07 -0.0696166551655795 +0.566 0.65120097647801 0.6511986672796249 9.063587226298964e-07 -0.06962448320671911 +0.5661 0.6512160086033815 0.6512136808286402 8.950038491994938e-07 -0.06963230959212145 +0.5662 0.65123103709095 0.6512286909667891 8.834668683010971e-07 -0.06964013432195067 +0.5663 0.6512460619394839 0.6512436976964214 8.717500436794534e-07 -0.06964795739637096 +0.5664 0.6512610831477742 0.6512587010198643 8.598556743844021e-07 -0.06965577881554667 +0.5665 0.651276100714635 0.651273700939422 8.477860941602522e-07 -0.06966359857964219 +0.5666 0.6512911146389038 0.6512886974573759 8.355436711404707e-07 -0.06967141668882201 +0.5667000000000001 0.651306124919441 0.6513036905759834 8.231308073758381e-07 -0.06967923314325064 +0.5668000000000001 0.6513211315551317 0.651318680297478 8.105499384181147e-07 -0.06968704794309274 +0.5669 0.6513361345448854 0.6513336666240697 7.978035326816624e-07 -0.06969486108851308 +0.567 0.6513511338876357 0.6513486495579436 7.84894091138133e-07 -0.06970267257967648 +0.5671 0.6513661295823409 0.6513636291012596 7.71824146650335e-07 -0.06971048241674778 +0.5672 0.6513811216279854 0.6513786052561528 7.585962638056998e-07 -0.06971829059989197 +0.5673 0.6513961100235784 0.651393578024733 7.452130379170807e-07 -0.0697260971292741 +0.5674 0.6514110947681558 0.6514085474090839 7.316770949256091e-07 -0.06973390200505936 +0.5675 0.6514260758607787 0.6514235134112636 7.179910906929265e-07 -0.06974170522741294 +0.5676 0.6514410533005353 0.6514384760333032 7.04157710570974e-07 -0.06974950679650012 +0.5677000000000001 0.65145602708654 0.6514534352772076 6.90179668833002e-07 -0.06975730671248634 +0.5678000000000001 0.6514709972179352 0.6514683911449546 6.760597081878483e-07 -0.06976510497553705 +0.5679 0.6514859636938897 0.6514833436384949 6.618005991415599e-07 -0.06977290158581782 +0.568 0.6515009265136003 0.6514982927597515 6.474051395810587e-07 -0.06978069654349427 +0.5681 0.6515158856762913 0.6515132385106202 6.328761541773975e-07 -0.06978848984873214 +0.5682 0.6515308411812154 0.6515281808929678 6.182164937473811e-07 -0.06979628150169719 +0.5683 0.6515457930276539 0.6515431199086338 6.034290348094773e-07 -0.06980407150255535 +0.5684 0.6515607412149164 0.6515580555594286 5.885166790564611e-07 -0.06981185985147255 +0.5685 0.6515756857423413 0.6515729878471336 5.734823526337696e-07 -0.06981964654861482 +0.5686 0.6515906266092968 0.6515879167735021 5.583290056954127e-07 -0.0698274315941484 +0.5687000000000001 0.6516055638151792 0.6516028423402573 5.430596117517172e-07 -0.06983521498823939 +0.5688000000000001 0.6516204973594157 0.6516177645490935 5.276771671836045e-07 -0.06984299673105412 +0.5689 0.6516354272414626 0.6516326834016745 5.121846904376781e-07 -0.06985077682275896 +0.569 0.6516503534608062 0.651647598899635 4.965852217903022e-07 -0.0698585552635204 +0.5691 0.6516652760169633 0.6516625110445788 4.808818224455447e-07 -0.06986633205350488 +0.5692 0.6516801949094815 0.6516774198380803 4.650775739939439e-07 -0.06987410719287916 +0.5693 0.6516951101379379 0.6516923252816823 4.4917557792678586e-07 -0.06988188068180985 +0.5694 0.6517100217019418 0.6517072273768978 4.3317895491445935e-07 -0.0698896525204638 +0.5695 0.6517249296011324 0.6517221261252082 4.170908443068555e-07 -0.0698974227090078 +0.5696 0.6517398338351807 0.6517370215280637 4.0091440338396733e-07 -0.06990519124760881 +0.5697000000000001 0.6517547344037892 0.651751913586884 3.846528068701671e-07 -0.0699129581364339 +0.5698000000000001 0.6517696313066916 0.6517668023030567 3.683092461570503e-07 -0.06992072337565018 +0.5699 0.6517845245436534 0.6517816876779378 3.518869287899573e-07 -0.0699284869654248 +0.57 0.6517994141144725 0.6517965697128517 3.3538907786428984e-07 -0.06993624890592508 +0.5701 0.651814300018978 0.6518114484090908 3.1881893130386585e-07 -0.06994400919731834 +0.5702 0.6518291822570316 0.6518263237679153 3.0217974130580805e-07 -0.069951767839772 +0.5703 0.6518440608285274 0.6518411957905534 2.854747736605323e-07 -0.06995952483345362 +0.5704 0.6518589357333919 0.6518560644782007 2.687073070370416e-07 -0.06996728017853077 +0.5705 0.6518738069715839 0.6518709298320204 2.518806325041423e-07 -0.06997503387517112 +0.5706 0.6518886745430954 0.6518857918531435 2.349980527602269e-07 -0.06998278592354248 +0.5707000000000001 0.6519035384479508 0.6519006505426675 2.180628815365293e-07 -0.06999053632381262 +0.5708000000000001 0.6519183986862075 0.6519155059016576 2.0107844293099086e-07 -0.06999828507614947 +0.5709 0.6519332552579563 0.6519303579311462 1.8404807076294327e-07 -0.07000603218072109 +0.571 0.6519481081633205 0.6519452066321321 1.6697510793473036e-07 -0.07001377763769552 +0.5711 0.651962957402457 0.6519600520055814 1.49862905717002e-07 -0.0700215214472409 +0.5712 0.6519778029755559 0.651974894052427 1.327148231693165e-07 -0.0700292636095255 +0.5713 0.6519926448828404 0.6519897327735686 1.1553422642196498e-07 -0.07003700412471765 +0.5714 0.6520074831245676 0.6520045681698723 9.832448803065441e-08 -0.07004474299298571 +0.5715 0.6520223177010278 0.652019400242171 8.108898635200701e-08 -0.07005248021449821 +0.5716 0.6520371486125449 0.652034228991264 6.383110481497645e-08 -0.07006021578942369 +0.5717000000000001 0.6520519758594767 0.652049054417917 4.655423129981684e-08 -0.0700679497179308 +0.5718000000000001 0.652066799442214 0.6520638765228628 2.9261757471948924e-08 -0.07007568200018827 +0.5719 0.6520816193611818 0.6520786953067998 1.195707810194846e-08 -0.0700834126363649 +0.572 0.6520964356168386 0.6520935107703936 -5.356409608393842e-09 -0.0700911416266296 +0.5721 0.6521112482096765 0.6521083229142755 -2.2675306665317918e-08 -0.07009886897115129 +0.5722 0.6521260571402215 0.6521231317390431 -3.999621297481534e-08 -0.07010659467009905 +0.5723 0.6521408624090335 0.652137937245261 -5.7315728001824245e-08 -0.07011431872364199 +0.5724 0.6521556640167057 0.6521527394334597 -7.463045143809785e-08 -0.0701220411319493 +0.5725 0.6521704619638651 0.652167538304136 -9.193698387310878e-08 -0.07012976189519024 +0.5726 0.652185256251173 0.6521823338577531 -1.0923192745627974e-07 -0.07013748101353423 +0.5727000000000001 0.6522000468793239 0.6521971260947411 -1.265118865778625e-07 -0.07014519848715069 +0.5728000000000001 0.6522148338490464 0.6522119150154958 -1.4377346852466333e-07 -0.07015291431620915 +0.5729 0.6522296171611024 0.6522267006203799 -1.6101328415007998e-07 -0.07016062850087922 +0.573 0.6522443968162872 0.6522414829097218 -1.7822794854197022e-07 -0.07016834104133055 +0.5731 0.6522591728154304 0.6522562618838175 -1.9541408167664254e-07 -0.07017605193773291 +0.5732 0.6522739451593946 0.6522710375429289 -2.1256830911101088e-07 -0.07018376119025617 +0.5733 0.652288713849076 0.6522858098872847 -2.2968726261576866e-07 -0.07019146879907022 +0.5734 0.6523034788854043 0.6523005789170799 -2.467675808415226e-07 -0.07019917476434508 +0.5735 0.6523182402693423 0.6523153446324771 -2.6380591004043774e-07 -0.07020687908625081 +0.5736 0.6523329980018863 0.6523301070336047 -2.8079890460747103e-07 -0.07021458176495757 +0.5737000000000001 0.6523477520840655 0.6523448661205588 -2.977432278505887e-07 -0.07022228280063557 +0.5738000000000001 0.6523625025169427 0.6523596218934021 -3.1463555258404163e-07 -0.07022998219345519 +0.5739 0.6523772493016133 0.6523743743521648 -3.3147256178756024e-07 -0.07023767994358679 +0.574 0.6523919924392054 0.6523891234968441 -3.482509493210606e-07 -0.07024537605120083 +0.5741 0.6524067319308805 0.6524038693274039 -3.649674205283282e-07 -0.07025307051646792 +0.5742 0.6524214677778322 0.6524186118437764 -3.816186928337628e-07 -0.07026076333955861 +0.5743 0.6524361999812869 0.6524333510458609 -3.9820149647096237e-07 -0.07026845452064368 +0.5744 0.6524509285425031 0.6524480869335245 -4.147125750794678e-07 -0.07027614405989382 +0.5745 0.6524656534627722 0.6524628195066025 -4.3114868639865245e-07 -0.07028383195748003 +0.5746 0.6524803747434169 0.6524775487648973 -4.475066028228336e-07 -0.07029151821357314 +0.5747000000000001 0.6524950923857928 0.6524922747081802 -4.6378311215067303e-07 -0.07029920282834426 +0.5748000000000001 0.6525098063912869 0.6525069973361899 -4.799750180778384e-07 -0.07030688580196442 +0.5749 0.6525245167613174 0.6525217166486345 -4.96079140932526e-07 -0.07031456713460486 +0.575 0.6525392234973348 0.65253643264519 -5.120923182583281e-07 -0.07032224682643683 +0.5751000000000001 0.6525539266008202 0.6525511453255013 -5.280114055150609e-07 -0.07032992487763157 +0.5752 0.6525686260732869 0.6525658546891825 -5.438332765644871e-07 -0.07033760128836063 +0.5753 0.652583321916278 0.6525805607358164 -5.595548243086945e-07 -0.07034527605879545 +0.5754 0.6525980141313679 0.6525952634649556 -5.75172961453374e-07 -0.0703529491891076 +0.5755 0.6526127027201618 0.6526099628761217 -5.906846209935424e-07 -0.07036062067946872 +0.5756 0.652627387684295 0.6526246589688063 -6.060867567547756e-07 -0.07036829053005055 +0.5757000000000001 0.6526420690254329 0.6526393517424709 -6.213763441703657e-07 -0.0703759587410249 +0.5758000000000001 0.6526567467452709 0.6526540411965472 -6.365503807254091e-07 -0.07038362531256363 +0.5759 0.6526714208455344 0.6526687273304372 -6.516058866368191e-07 -0.07039129024483877 +0.576 0.6526860913279782 0.6526834101435132 -6.665399053390475e-07 -0.07039895353802231 +0.5761000000000001 0.6527007581943859 0.6526980896351187 -6.813495042612416e-07 -0.07040661519228635 +0.5762 0.6527154214465706 0.6527127658045679 -6.96031775201944e-07 -0.07041427520780309 +0.5763 0.6527300810863742 0.6527274386511466 -7.105838350091043e-07 -0.07042193358474483 +0.5764 0.652744737115667 0.652742108174112 -7.250028260380459e-07 -0.0704295903232839 +0.5765 0.6527593895363478 0.6527567743726935 -7.392859168869892e-07 -0.07043724542359277 +0.5766 0.652774038350343 0.6527714372460918 -7.534303029382849e-07 -0.07044489888584388 +0.5767 0.6527886835596071 0.6527860967934803 -7.674332067608702e-07 -0.07045255071020982 +0.5768000000000001 0.6528033251661216 0.6528007530140054 -7.812918786931355e-07 -0.0704602008968633 +0.5769 0.6528179631718959 0.6528154059067859 -7.95003597481303e-07 -0.07046784944597699 +0.577 0.652832597578966 0.6528300554709137 -8.085656708622935e-07 -0.07047549635772375 +0.5771000000000001 0.6528472283893944 0.6528447017054544 -8.219754358135267e-07 -0.07048314163227647 +0.5772 0.6528618556052701 0.6528593446094475 -8.352302594272221e-07 -0.07049078526980809 +0.5773 0.6528764792287083 0.6528739841819062 -8.483275391601985e-07 -0.0704984272704917 +0.5774 0.6528910992618494 0.6528886204218183 -8.61264703611031e-07 -0.07050606763450039 +0.5775 0.6529057157068598 0.6529032533281458 -8.740392127559726e-07 -0.07051370636200736 +0.5776 0.6529203285659306 0.6529178828998264 -8.866485584346773e-07 -0.07052134345318592 +0.5777 0.6529349378412781 0.6529325091357726 -8.990902653494004e-07 -0.07052897890820937 +0.5778000000000001 0.6529495435351425 0.6529471320348725 -9.113618908984655e-07 -0.07053661272725117 +0.5779 0.6529641456497887 0.6529617515959902 -9.234610261199538e-07 -0.07054424491048482 +0.578 0.6529787441875051 0.6529763678179663 -9.353852957749709e-07 -0.07055187545808389 +0.5781000000000001 0.6529933391506038 0.6529909806996177 -9.471323593190917e-07 -0.07055950437022204 +0.5782 0.6530079305414195 0.6530055902397385 -9.586999108190941e-07 -0.070567131647073 +0.5783 0.6530225183623104 0.6530201964371 -9.700856798133817e-07 -0.07057475728881062 +0.5784 0.6530371026156566 0.6530347992904514 -9.81287431534028e-07 -0.07058238129560879 +0.5785 0.6530516833038605 0.6530493987985191 -9.923029676561779e-07 -0.07059000366764139 +0.5786 0.653066260429346 0.6530639949600089 -1.0031301262980463e-06 -0.07059762440508256 +0.5787 0.6530808339945589 0.653078587773605 -1.0137667826592978e-06 -0.07060524350810637 +0.5788000000000001 0.6530954040019649 0.6530931772379701 -1.0242108496039126e-06 -0.07061286097688702 +0.5789 0.6531099704540515 0.6531077633517475 -1.0344602778544765e-06 -0.07062047681159882 +0.579 0.6531245333533258 0.6531223461135595 -1.0445130564085137e-06 -0.07062809101241606 +0.5791000000000001 0.6531390927023144 0.6531369255220086 -1.054367213010332e-06 -0.07063570357951314 +0.5792 0.6531536485035643 0.6531515015756786 -1.0640208145951124e-06 -0.0706433145130646 +0.5793 0.6531682007596407 0.653166074273134 -1.073471967427686e-06 -0.07065092381324507 +0.5794 0.6531827494731277 0.6531806436129202 -1.0827188179074465e-06 -0.07065853148022909 +0.5795 0.6531972946466282 0.6531952095935651 -1.091759552429572e-06 -0.07066613751419144 +0.5796 0.6532118362827621 0.6532097722135788 -1.1005923981621812e-06 -0.07067374191530693 +0.5797 0.6532263743841673 0.6532243314714533 -1.1092156231018446e-06 -0.07068134468375036 +0.5798000000000001 0.653240908953499 0.6532388873656647 -1.1176275365731847e-06 -0.0706889458196968 +0.5799 0.653255439993428 0.6532534398946714 -1.125826489561943e-06 -0.07069654532332122 +0.58 0.653269967506643 0.6532679890569164 -1.133810875103558e-06 -0.07070414319479872 +0.5801000000000001 0.6532844914958471 0.6532825348508269 -1.14157912825541e-06 -0.07071173943430452 +0.5802 0.653299011963759 0.6532970772748142 -1.1491297270127543e-06 -0.07071933404201378 +0.5803 0.6533135289131125 0.6533116163272756 -1.1564611918646328e-06 -0.07072692701810186 +0.5804 0.6533280423466568 0.6533261520065933 -1.16357208682083e-06 -0.07073451836274425 +0.5805 0.6533425522671539 0.6533406843111357 -1.1704610192175835e-06 -0.07074210807611635 +0.5806 0.65335705867738 0.653355213239257 -1.1771266401339187e-06 -0.0707496961583937 +0.5807 0.6533715615801252 0.6533697387892994 -1.1835676448357368e-06 -0.07075728260975199 +0.5808000000000001 0.6533860609781914 0.6533842609595915 -1.1897827724705046e-06 -0.07076486743036689 +0.5809 0.6534005568743934 0.6533987797484497 -1.1957708070386985e-06 -0.07077245062041419 +0.581 0.6534150492715578 0.6534132951541789 -1.20153057736605e-06 -0.07078003218006976 +0.5811000000000001 0.6534295381725226 0.6534278071750723 -1.2070609570202784e-06 -0.0707876121095095 +0.5812 0.653444023580137 0.6534423158094125 -1.2123608649494688e-06 -0.07079519040890944 +0.5813 0.6534585054972606 0.6534568210554708 -1.2174292655098284e-06 -0.0708027670784456 +0.5814 0.6534729839267632 0.6534713229115093 -1.222265168798753e-06 -0.0708103421182942 +0.5815 0.6534874588715246 0.6534858213757804 -1.2268676305993154e-06 -0.07081791552863145 +0.5816 0.6535019303344333 0.653500316446527 -1.2312357527966e-06 -0.07082548730963367 +0.5817 0.6535163983183868 0.653514808121983 -1.23536868351648e-06 -0.07083305746147722 +0.5818000000000001 0.6535308628262908 0.6535292964003752 -1.2392656173199068e-06 -0.07084062598433853 +0.5819 0.6535453238610589 0.6535437812799216 -1.242925795036376e-06 -0.07084819287839417 +0.582 0.6535597814256124 0.6535582627588337 -1.2463485047631284e-06 -0.07085575814382075 +0.5821000000000001 0.6535742355228791 0.6535727408353152 -1.249533080727172e-06 -0.0708633217807949 +0.5822 0.6535886861557929 0.6535872155075642 -1.2524789047008156e-06 -0.07087088378949334 +0.5823 0.6536031333272947 0.6536016867737724 -1.2551854052522682e-06 -0.07087844417009292 +0.5824 0.6536175770403301 0.6536161546321267 -1.2576520582729955e-06 -0.07088600292277061 +0.5825 0.6536320172978498 0.6536306190808088 -1.259878386894453e-06 -0.07089356004770331 +0.5826 0.6536464541028097 0.6536450801179952 -1.2618639618211525e-06 -0.07090111554506809 +0.5827 0.653660887458169 0.6536595377418594 -1.2636084010253512e-06 -0.07090866941504205 +0.5828000000000001 0.653675317366891 0.6536739919505704 -1.265111370191141e-06 -0.07091622165780236 +0.5829 0.653689743831942 0.6536884427422951 -1.2663725827144479e-06 -0.07092377227352635 +0.583 0.6537041668562908 0.6537028901151971 -1.2673917996475215e-06 -0.07093132126239132 +0.5831000000000001 0.6537185864429089 0.6537173340674384 -1.2681688296989346e-06 -0.07093886862457471 +0.5832 0.6537330025947692 0.6537317745971786 -1.268703529594406e-06 -0.07094641436025399 +0.5833 0.653747415314846 0.6537462117025769 -1.2689958037159776e-06 -0.07095395846960677 +0.5834 0.6537618246061141 0.6537606453817909 -1.269045604351815e-06 -0.07096150095281062 +0.5835 0.6537762304715486 0.6537750756329791 -1.268852931640696e-06 -0.07096904181004327 +0.5836 0.653790632914125 0.6537895024542992 -1.2684178335997665e-06 -0.07097658104148251 +0.5837 0.6538050319368176 0.6538039258439102 -1.267740405930251e-06 -0.07098411864730618 +0.5838000000000001 0.6538194275425996 0.6538183457999723 -1.2668207925170538e-06 -0.0709916546276922 +0.5839 0.6538338197344431 0.6538327623206472 -1.2656591848181353e-06 -0.07099918898281865 +0.584 0.6538482085153174 0.6538471754040986 -1.2642558221420686e-06 -0.07100672171286353 +0.5841000000000001 0.6538625938881895 0.6538615850484929 -1.2626109913982386e-06 -0.07101425281800494 +0.5842 0.6538769758560239 0.653875991252 -1.2607250274021542e-06 -0.07102178229842121 +0.5843 0.6538913544217811 0.6538903940127933 -1.2585983124591138e-06 -0.07102931015429062 +0.5844 0.6539057295884179 0.6539047933290496 -1.2562312762809391e-06 -0.07103683638579153 +0.5845 0.6539201013588862 0.6539191891989506 -1.2536243964300642e-06 -0.07104436099310237 +0.5846 0.6539344697361331 0.6539335816206829 -1.2507781975146237e-06 -0.0710518839764016 +0.5847 0.6539488347231008 0.6539479705924391 -1.2476932512439642e-06 -0.07105940533586787 +0.5848000000000001 0.6539631963227253 0.6539623561124168 -1.2443701769837556e-06 -0.07106692507167982 +0.5849 0.6539775545379365 0.6539767381788211 -1.2408096406735236e-06 -0.07107444318401622 +0.585 0.6539919093716569 0.6539911167898629 -1.2370123555205392e-06 -0.07108195967305585 +0.5851000000000001 0.6540062608268022 0.6540054919437608 -1.2329790813059294e-06 -0.07108947453897752 +0.5852 0.6540206089062808 0.6540198636387413 -1.2287106244124324e-06 -0.07109698778196029 +0.5853 0.654034953612992 0.6540342318730394 -1.2242078375190868e-06 -0.07110449940218315 +0.5854 0.6540492949498271 0.6540485966448981 -1.219471620073076e-06 -0.07111200939982512 +0.5855 0.6540636329196684 0.6540629579525705 -1.2145029172350164e-06 -0.07111951777506549 +0.5856 0.6540779675253878 0.6540773157943183 -1.2093027203230466e-06 -0.0711270245280834 +0.5857 0.6540922987698481 0.6540916701684143 -1.2038720662577163e-06 -0.07113452965905821 +0.5858000000000001 0.654106626655901 0.6541060210731411 -1.1982120375342298e-06 -0.07114203316816929 +0.5859 0.654120951186388 0.6541203685067926 -1.192323762028158e-06 -0.07114953505559612 +0.586 0.6541352723641385 0.6541347124676741 -1.1862084126068595e-06 -0.07115703532151825 +0.5861000000000001 0.6541495901919702 0.6541490529541027 -1.1798672070739702e-06 -0.0711645339661152 +0.5862 0.6541639046726886 0.6541633899644079 -1.1733014079751136e-06 -0.07117203098956663 +0.5863 0.654178215809087 0.6541777234969324 -1.1665123220705453e-06 -0.07117952639205243 +0.5864 0.6541925236039446 0.6541920535500314 -1.1595013002518861e-06 -0.07118702017375227 +0.5865 0.654206828060028 0.6542063801220741 -1.1522697374310997e-06 -0.07119451233484612 +0.5866 0.6542211291800888 0.654220703211444 -1.1448190719576257e-06 -0.07120200287551388 +0.5867 0.6542354269668651 0.6542350228165387 -1.137150785701646e-06 -0.07120949179593566 +0.5868000000000001 0.6542497214230791 0.6542493389357706 -1.1292664034157074e-06 -0.07121697909629145 +0.5869 0.6542640125514387 0.6542636515675685 -1.1211674924016535e-06 -0.07122446477676152 +0.587 0.6542783003546357 0.6542779607103761 -1.1128556625661368e-06 -0.07123194883752612 +0.5871000000000001 0.6542925848353454 0.6542922663626539 -1.1043325660597958e-06 -0.07123943127876556 +0.5872 0.6543068659962266 0.6543065685228782 -1.095599896500099e-06 -0.07124691210066017 +0.5873 0.6543211438399212 0.6543208671895431 -1.0866593890823673e-06 -0.07125439130339047 +0.5873999999999999 0.6543354183690543 0.6543351623611597 -1.0775128200524176e-06 -0.07126186888713693 +0.5875 0.6543496895862322 0.6543494540362578 -1.0681620065122743e-06 -0.07126934485208021 +0.5876 0.6543639574940434 0.6543637422133844 -1.0586088058650578e-06 -0.07127681919840098 +0.5877 0.6543782220950582 0.6543780268911061 -1.048855115481917e-06 -0.07128429192627998 +0.5878000000000001 0.6543924833918273 0.6543923080680079 -1.0389028724244742e-06 -0.07129176303589804 +0.5879 0.6544067413868823 0.6544065857426946 -1.0287540531117578e-06 -0.07129923252743604 +0.588 0.6544209960827345 0.6544208599137908 -1.0184106728483577e-06 -0.07130670040107492 +0.5881000000000001 0.654435247481876 0.6544351305799415 -1.0078747852415582e-06 -0.07131416665699572 +0.5882000000000001 0.6544494955867773 0.654449397739812 -9.971484820348042e-07 -0.07132163129537954 +0.5883 0.6544637403998887 0.6544636613920888 -9.862338927191239e-07 -0.07132909431640756 +0.5883999999999999 0.6544779819236388 0.6544779215354799 -9.751331840335276e-07 -0.07133655572026103 +0.5885 0.6544922201604347 0.6544921781687146 -9.638485594654078e-07 -0.0713440155071212 +0.5886 0.6545064551126614 0.6545064312905449 -9.523822588619613e-07 -0.07135147367716953 +0.5887 0.6545206867826813 0.6545206808997448 -9.407365580693661e-07 -0.07135893023058743 +0.5888000000000001 0.6545349151728345 0.6545349269951115 -9.289137684331816e-07 -0.07136638516755645 +0.5889 0.6545491402854373 0.6545491695754653 -9.169162362987482e-07 -0.07137383848825819 +0.589 0.6545633621227833 0.6545634086396497 -9.047463426503644e-07 -0.0713812901928743 +0.5891000000000001 0.6545775806871417 0.6545776441865323 -8.924065024451533e-07 -0.07138874028158652 +0.5892000000000001 0.6545917959807581 0.654591876215005 -8.798991642799958e-07 -0.07139618875457665 +0.5893 0.6546060080058529 0.6546061047239843 -8.672268101417302e-07 -0.0714036356120266 +0.5893999999999999 0.6546202167646223 0.6546203297124111 -8.54391954435707e-07 -0.07141108085411825 +0.5895 0.6546344222592372 0.654634551179252 -8.413971436804779e-07 -0.07141852448103367 +0.5896 0.654648624491843 0.6546487691234988 -8.282449561886063e-07 -0.07142596649295495 +0.5897 0.6546628234645595 0.6546629835441693 -8.149380014005336e-07 -0.07143340689006421 +0.5898000000000001 0.6546770191794802 0.6546771944403074 -8.014789193017124e-07 -0.0714408456725437 +0.5899 0.6546912116386724 0.6546914018109833 -7.878703800617837e-07 -0.07144828284057574 +0.59 0.6547054008441766 0.654705605655294 -7.741150834100763e-07 -0.07145571839434268 +0.5901000000000001 0.6547195867980065 0.6547198059723638 -7.60215758136007e-07 -0.07146315233402695 +0.5902000000000001 0.6547337695021482 0.6547340027613437 -7.461751615062129e-07 -0.07147058465981103 +0.5903 0.6547479489585607 0.6547481960214132 -7.319960787788293e-07 -0.07147801537187755 +0.5903999999999999 0.6547621251691751 0.6547623857517785 -7.176813225373557e-07 -0.07148544447040911 +0.5905 0.6547762981358944 0.6547765719516749 -7.032337323575888e-07 -0.0714928719555885 +0.5906 0.6547904678605931 0.6547907546203658 -6.886561740165886e-07 -0.07150029782759841 +0.5907 0.6548046343451173 0.6548049337571432 -6.739515390763451e-07 -0.07150772208662175 +0.5908000000000001 0.6548187975912839 0.654819109361328 -6.591227441760106e-07 -0.07151514473284143 +0.5909 0.6548329576008809 0.6548332814322702 -6.441727306016887e-07 -0.07152256576644042 +0.591 0.6548471143756673 0.6548474499693497 -6.291044636480558e-07 -0.07152998518760183 +0.5911000000000001 0.654861267917372 0.6548616149719753 -6.139209319522276e-07 -0.07153740299650874 +0.5912000000000001 0.6548754182276941 0.654875776439586 -5.986251470219139e-07 -0.07154481919334438 +0.5913 0.6548895653083034 0.6548899343716515 -5.832201425970407e-07 -0.07155223377829208 +0.5913999999999999 0.6549037091608386 0.6549040887676709 -5.677089740391272e-07 -0.07155964675153507 +0.5915 0.6549178497869081 0.654918239627174 -5.520947176373969e-07 -0.07156705811325681 +0.5916 0.6549319871880899 0.6549323869497219 -5.363804702340769e-07 -0.07157446786364079 +0.5917 0.6549461213659309 0.6549465307349064 -5.205693483362195e-07 -0.07158187600287057 +0.5918000000000001 0.6549602523219468 0.65496067098235 -5.046644877132467e-07 -0.07158928253112971 +0.5919 0.6549743800576225 0.6549748076917069 -4.886690427030604e-07 -0.07159668744860195 +0.592 0.6549885045744109 0.6549889408626629 -4.7258618550427567e-07 -0.07160409075547101 +0.5921000000000001 0.6550026258737336 0.6550030704949354 -4.564191057043754e-07 -0.07161149245192071 +0.5922000000000001 0.6550167439569804 0.6550171965882736 -4.401710095303102e-07 -0.07161889253813496 +0.5923 0.6550308588255089 0.6550313191424588 -4.238451192586923e-07 -0.07162629101429772 +0.5923999999999999 0.6550449704806449 0.6550454381573043 -4.0744467254272276e-07 -0.07163368788059303 +0.5925 0.6550590789236818 0.6550595536326557 -3.9097292182932453e-07 -0.07164108313720491 +0.5926 0.6550731841558803 0.6550736655683913 -3.7443313368606956e-07 -0.0716484767843176 +0.5927 0.655087286178469 0.6550877739644219 -3.578285880934118e-07 -0.07165586882211528 +0.5928000000000001 0.6551013849926438 0.6551018788206912 -3.4116257793120885e-07 -0.07166325925078229 +0.5929 0.6551154805995675 0.6551159801371754 -3.244384081946272e-07 -0.07167064807050301 +0.593 0.65512957300037 0.6551300779138842 -3.0765939541821385e-07 -0.07167803528146185 +0.5931000000000001 0.6551436621961482 0.65514417215086 -2.9082886697506805e-07 -0.07168542088384332 +0.5932000000000001 0.6551577481879661 0.6551582628481786 -2.739501604523409e-07 -0.07169280487783201 +0.5933 0.6551718309768543 0.6551723500059488 -2.570266229642848e-07 -0.07170018726361255 +0.5933999999999999 0.6551859105638098 0.6551864336243133 -2.4006161049305863e-07 -0.07170756804136967 +0.5935 0.6551999869497965 0.6552005137034478 -2.2305848720524657e-07 -0.07171494721128811 +0.5936 0.6552140601357447 0.6552145902435618 -2.0602062485858275e-07 -0.07172232477355274 +0.5937 0.655228130122551 0.6552286632448985 -1.889514020386729e-07 -0.07172970072834846 +0.5938000000000001 0.6552421969110785 0.6552427327077344 -1.7185420355878e-07 -0.07173707507586025 +0.5939 0.6552562605021568 0.6552567986323804 -1.547324197451183e-07 -0.07174444781627319 +0.594 0.6552703208965813 0.655270861019181 -1.3758944579500554e-07 -0.07175181894977238 +0.5941000000000001 0.6552843780951139 0.6552849198685139 -1.2042868106736104e-07 -0.07175918847654299 +0.5942000000000001 0.6552984320984824 0.6552989751807915 -1.0325352845820535e-07 -0.0717665563967703 +0.5943 0.6553124829073811 0.6553130269564601 -8.606739368421934e-08 -0.0717739227106396 +0.5943999999999999 0.6553265305224701 0.6553270751959994 -6.887368462615145e-08 -0.07178128741833632 +0.5945 0.6553405749443758 0.6553411198999233 -5.1675810644902925e-08 -0.07178865052004586 +0.5946 0.6553546161736904 0.65535516106878 -3.447718191084033e-08 -0.07179601201595377 +0.5947 0.6553686542109722 0.6553691987031515 -1.7281208724868186e-08 -0.07180337190624562 +0.5948000000000001 0.6553826890567458 0.6553832328036537 -9.130083841735193e-11 -0.0718107301911071 +0.5949 0.6553967207115019 0.6553972633709366 1.7089133216158237e-08 -0.07181808687072394 +0.595 0.6554107491756969 0.6554112904056839 3.425668681014682e-08 -0.07182544194528187 +0.5951000000000001 0.6554247744497538 0.6554253139086136 5.1407955890467316e-08 -0.07183279541496682 +0.5952000000000001 0.655438796534061 0.6554393338804775 6.853953964623682e-08 -0.07184014727996464 +0.5953 0.655452815428974 0.6554533503220612 8.564804119745584e-08 -0.0718474975404614 +0.5953999999999999 0.6554668311348137 0.6554673632341843 1.0273006827501985e-07 -0.0718548461966431 +0.5955 0.6554808436518678 0.6554813726177001 1.19782233881649e-07 -0.07186219324869586 +0.5956 0.6554948529803901 0.6554953784734955 1.3680115694414408e-07 -0.07186953869680593 +0.5957 0.655508859120601 0.6555093808024914 1.537834630402357e-07 -0.07187688254115955 +0.5958000000000001 0.6555228620726867 0.6555233796056421 1.7072578501614588e-07 -0.071884224781943 +0.5959 0.6555368618368007 0.6555373748839355 1.8762476367700787e-07 -0.07189156541934273 +0.596 0.6555508584130625 0.6555513666383928 2.0447704846687786e-07 -0.07189890445354519 +0.5961000000000001 0.6555648518015588 0.6555653548700687 2.2127929808629654e-07 -0.07190624188473686 +0.5962000000000001 0.6555788420023427 0.6555793395800512 2.3802818123475067e-07 -0.0719135777131044 +0.5963 0.6555928290154345 0.6555933207694614 2.5472037720047913e-07 -0.0719209119388344 +0.5963999999999999 0.6556068128408209 0.6556072984394534 2.713525765543623e-07 -0.07192824456211361 +0.5965 0.6556207934784565 0.6556212725912146 2.8792148178136134e-07 -0.07193557558312885 +0.5966 0.6556347709282627 0.6556352432259647 3.044238079813466e-07 -0.07194290500206695 +0.5967 0.6556487451901282 0.6556492103449563 3.2085628349359796e-07 -0.07195023281911483 +0.5968000000000001 0.6556627162639093 0.6556631739494749 3.372156505074275e-07 -0.0719575590344595 +0.5969 0.6556766841494299 0.6556771340408378 3.534986657907635e-07 -0.071964883648288 +0.597 0.6556906488464818 0.6556910906203952 3.6970210130077286e-07 -0.07197220666078744 +0.5971000000000001 0.6557046103548247 0.655705043689529 3.85822744794484e-07 -0.07197952807214505 +0.5972000000000001 0.6557185686741861 0.655718993249653 4.0185740052267604e-07 -0.07198684788254801 +0.5973 0.6557325238042622 0.6557329393022131 4.1780288979886837e-07 -0.07199416609218372 +0.5973999999999999 0.6557464757447171 0.6557468818486868 4.3365605169320975e-07 -0.0720014827012395 +0.5975 0.6557604244951842 0.6557608208905827 4.494137436222845e-07 -0.07200879770990286 +0.5976 0.6557743700552653 0.6557747564294415 4.6507284195973497e-07 -0.0720161111183613 +0.5977 0.6557883124245308 0.6557886884668337 4.806302427856624e-07 -0.07202342292680237 +0.5978000000000001 0.655802251602521 0.6558026170043614 4.960828623307156e-07 -0.07203073313541374 +0.5979 0.6558161875887455 0.6558165420436575 5.114276376005922e-07 -0.07203804174438314 +0.598 0.6558301203826828 0.6558304635863851 5.266615271531938e-07 -0.07204534875389831 +0.5981000000000001 0.6558440499837823 0.6558443816342374 5.417815115843494e-07 -0.07205265416414715 +0.5982000000000001 0.6558579763914621 0.6558582961889379 5.567845940829264e-07 -0.07205995797531749 +0.5983 0.6558718996051119 0.6558722072522397 5.7166780112472e-07 -0.07206726018759739 +0.5983999999999999 0.655885819624091 0.6558861148259258 5.864281829581763e-07 -0.07207456080117483 +0.5985 0.6558997364477296 0.6559000189118078 6.010628144231811e-07 -0.07208185981623794 +0.5986 0.6559136500753292 0.6559139195117274 6.155687952424937e-07 -0.07208915723297488 +0.5987 0.6559275605061624 0.655927816627554 6.299432507017588e-07 -0.0720964530515739 +0.5988000000000001 0.6559414677394734 0.6559417102611861 6.441833323850288e-07 -0.07210374727222334 +0.5989 0.6559553717744774 0.6559556004145508 6.582862184245641e-07 -0.07211103989511146 +0.599 0.6559692726103628 0.6559694870896026 6.722491143335008e-07 -0.07211833092042678 +0.5991000000000001 0.6559831702462893 0.6559833702883242 6.86069253519328e-07 -0.07212562034835777 +0.5992000000000001 0.6559970646813897 0.6559972500127256 6.997438976724668e-07 -0.07213290817909297 +0.5993 0.6560109559147697 0.6560111262648441 7.132703375017924e-07 -0.07214019441282106 +0.5993999999999999 0.6560248439455079 0.6560249990467437 7.266458932203568e-07 -0.07214747904973069 +0.5995 0.6560387287726562 0.6560388683605151 7.398679149339671e-07 -0.0721547620900106 +0.5996 0.6560526103952407 0.6560527342082753 7.529337834044636e-07 -0.07216204353384963 +0.5997 0.6560664888122614 0.6560665965921673 7.658409103827868e-07 -0.07216932338143664 +0.5998000000000001 0.6560803640226928 0.6560804555143599 7.785867392751111e-07 -0.07217660163296062 +0.5999 0.6560942360254836 0.6560943109770471 7.911687455175453e-07 -0.0721838782886106 +0.6 0.6561081048195578 0.6561081629824479 8.035844371312439e-07 -0.0721911533485756 +0.6001000000000001 0.6561219704038147 0.6561220115328062 8.158313553330299e-07 -0.07219842681304477 +0.6002000000000001 0.6561358327771297 0.6561358566303903 8.279070746741723e-07 -0.07220569868220737 +0.6003000000000001 0.6561496919383534 0.656149698277492 8.398092040673433e-07 -0.0722129689562526 +0.6003999999999999 0.6561635478863129 0.6561635364764278 8.515353868143727e-07 -0.07222023763536982 +0.6005 0.6561774006198128 0.6561773712295366 8.630833012446271e-07 -0.07222750471974845 +0.6006 0.6561912501376339 0.6561912025391806 8.744506610203207e-07 -0.07223477020957791 +0.6007 0.6562050964385345 0.6562050304077454 8.856352159691827e-07 -0.07224203410504779 +0.6008000000000001 0.6562189395212511 0.6562188548376376 8.966347522232354e-07 -0.07224929640634763 +0.6009 0.6562327793844978 0.6562326758312867 9.074470927183942e-07 -0.07225655711366709 +0.601 0.6562466160269675 0.6562464933911436 9.180700975830458e-07 -0.07226381622719591 +0.6011 0.6562604494473319 0.6562603075196797 9.285016646098931e-07 -0.07227107374712383 +0.6012000000000001 0.6562742796442418 0.6562741182193881 9.387397298388223e-07 -0.07227832967364074 +0.6013000000000001 0.6562881066163277 0.656287925492782 9.487822676679247e-07 -0.07228558400693655 +0.6013999999999999 0.6563019303622006 0.6563017293423945 9.586272913808536e-07 -0.0722928367472012 +0.6015 0.6563157508804511 0.6563155297707783 9.682728537574459e-07 -0.0723000878946248 +0.6016 0.6563295681696508 0.6563293267805058 9.777170472402563e-07 -0.0723073374493974 +0.6017 0.6563433822283528 0.6563431203741678 9.869580042121129e-07 -0.07231458541170911 +0.6018000000000001 0.6563571930550911 0.6563569105543735 9.959938976622507e-07 -0.07232183178175018 +0.6019 0.6563710006483829 0.6563706973237509 1.0048229411863119e-06 -0.07232907655971098 +0.602 0.6563848050067268 0.6563844806849449 1.0134433897912576e-06 -0.07233631974578185 +0.6021 0.6563986061286042 0.6563982606406178 1.0218535398953676e-06 -0.07234356134015316 +0.6022000000000001 0.6564124040124804 0.6564120371934485 1.030051729827841e-06 -0.07235080134301533 +0.6023000000000001 0.6564261986568036 0.656425810346133 1.0380363400230852e-06 -0.07235803975455901 +0.6023999999999999 0.6564399900600068 0.6564395801013827 1.0458057935203158e-06 -0.07236527657497478 +0.6025 0.6564537782205069 0.6564533464619247 1.0533585561578462e-06 -0.07237251180445328 +0.6026 0.656467563136706 0.656467109430501 1.0606931369616657e-06 -0.07237974544318529 +0.6027 0.6564813448069915 0.6564808690098687 1.0678080883397278e-06 -0.07238697749136155 +0.6028000000000001 0.6564951232297367 0.656494625202799 1.0747020064982848e-06 -0.07239420794917295 +0.6029 0.6565088984033006 0.6565083780120768 1.0813735315251538e-06 -0.07240143681681042 +0.603 0.65652267032603 0.6565221274405008 1.0878213479170729e-06 -0.07240866409446496 +0.6031 0.6565364389962576 0.6565358734908817 1.0940441846907234e-06 -0.07241588978232759 +0.6032000000000001 0.6565502044123042 0.6565496161660438 1.1000408156325303e-06 -0.07242311388058943 +0.6033000000000001 0.6565639665724784 0.6565633554688224 1.1058100596317288e-06 -0.07243033638944162 +0.6033999999999999 0.6565777254750778 0.6565770914020652 1.111350780791387e-06 -0.07243755730907545 +0.6035 0.6565914811183884 0.656590823968631 1.116661888705961e-06 -0.07244477663968221 +0.6036 0.6566052335006853 0.6566045531713884 1.1217423388221182e-06 -0.07245199438145321 +0.6037 0.656618982620234 0.6566182790132173 1.1265911323277145e-06 -0.07245921053457986 +0.6038000000000001 0.65663272847529 0.656632001497007 1.1312073167069059e-06 -0.07246642509925372 +0.6039 0.6566464710640996 0.6566457206256557 1.135589985712393e-06 -0.0724736380756663 +0.604 0.6566602103849004 0.6566594364020709 1.1397382797262434e-06 -0.0724808494640092 +0.6041 0.6566739464359215 0.6566731488291685 1.1436513855656028e-06 -0.07248805926447413 +0.6042000000000001 0.6566876792153841 0.6566868579098719 1.1473285370933173e-06 -0.07249526747725278 +0.6043000000000001 0.6567014087215022 0.6567005636471123 1.1507690152456895e-06 -0.07250247410253699 +0.6043999999999999 0.6567151349524828 0.6567142660438279 1.153972147921456e-06 -0.07250967914051858 +0.6045 0.6567288579065262 0.6567279651029629 1.1569373102315872e-06 -0.0725168825913895 +0.6046 0.6567425775818271 0.6567416608274683 1.1596639249711327e-06 -0.07252408445534174 +0.6047 0.6567562939765742 0.6567553532203002 1.1621514622583984e-06 -0.07253128473256727 +0.6048000000000001 0.656770007088952 0.6567690422844195 1.1643994398680135e-06 -0.07253848342325829 +0.6049 0.6567837169171392 0.656782728022792 1.1664074232864419e-06 -0.07254568052760686 +0.605 0.6567974234593115 0.656796410438388 1.168175025878515e-06 -0.07255287604580528 +0.6051 0.6568111267136407 0.6568100895341811 1.1697019088596772e-06 -0.07256006997804586 +0.6052000000000001 0.6568248266782951 0.6568237653131477 1.1709877814070069e-06 -0.07256726232452093 +0.6053000000000001 0.6568385233514409 0.6568374377782674 1.1720324007979954e-06 -0.07257445308542289 +0.6053999999999999 0.6568522167312415 0.656851106932522 1.1728355722440131e-06 -0.07258164226094421 +0.6055 0.6568659068158591 0.656864772778895 1.173397149251132e-06 -0.07258882985127744 +0.6056 0.6568795936034546 0.6568784353203705 1.1737170332037916e-06 -0.07259601585661517 +0.6057 0.6568932770921883 0.6568920945599345 1.173795173892156e-06 -0.07260320027715006 +0.6058000000000001 0.6569069572802195 0.6569057505005724 1.1736315691790455e-06 -0.07261038311307486 +0.6059 0.6569206341657088 0.65691940314527 1.1732262650832048e-06 -0.07261756436458232 +0.606 0.6569343077468169 0.6569330524970118 1.1725793559180797e-06 -0.0726247440318653 +0.6061 0.6569479780217058 0.6569466985587815 1.1716909839309952e-06 -0.0726319221151167 +0.6062000000000001 0.6569616449885392 0.6569603413335614 1.1705613396084669e-06 -0.07263909861452948 +0.6063000000000001 0.6569753086454826 0.6569739808243313 1.1691906615651781e-06 -0.07264627353029669 +0.6063999999999999 0.6569889689907047 0.6569876170340687 1.1675792364884696e-06 -0.07265344686261137 +0.6065 0.6570026260223771 0.6570012499657476 1.1657273987775163e-06 -0.07266061861166671 +0.6066 0.6570162797386749 0.6570148796223386 1.163635531181706e-06 -0.0726677887776559 +0.6067 0.6570299301377774 0.6570285060068088 1.161304063884705e-06 -0.07267495736077222 +0.6068000000000001 0.6570435772178683 0.6570421291221202 1.1587334751150813e-06 -0.07268212436120901 +0.6069 0.6570572209771365 0.6570557489712299 1.155924290563437e-06 -0.07268928977915963 +0.607 0.6570708614137762 0.6570693655570896 1.1528770836599644e-06 -0.07269645361481757 +0.6071 0.6570844985259876 0.657082978882645 1.1495924752136233e-06 -0.07270361586837629 +0.6072000000000001 0.6570981323119778 0.6570965889508358 1.146071133273363e-06 -0.07271077654002943 +0.6073000000000001 0.6571117627699601 0.6571101957645942 1.142313773128123e-06 -0.07271793562997057 +0.6073999999999999 0.6571253898981555 0.6571237993268453 1.1383211572513208e-06 -0.07272509313839345 +0.6075 0.657139013694793 0.6571373996405062 1.134094094829008e-06 -0.07273224906549174 +0.6076 0.6571526341581102 0.6571509967084865 1.1296334418431364e-06 -0.07273940341145939 +0.6077 0.6571662512863525 0.6571645905336861 1.1249401008772697e-06 -0.07274655617649017 +0.6078000000000001 0.6571798650777756 0.6571781811189961 1.120015021033316e-06 -0.07275370736077805 +0.6079 0.6571934755306443 0.6571917684672974 1.1148591973764166e-06 -0.072760856964517 +0.608 0.6572070826432341 0.6572053525814618 1.1094736709904574e-06 -0.07276800498790113 +0.6081 0.6572206864138304 0.6572189334643496 1.103859529005824e-06 -0.0727751514311245 +0.6082000000000001 0.6572342868407303 0.6572325111188104 1.098017904016535e-06 -0.07278229629438134 +0.6083000000000001 0.6572478839222422 0.657246085547682 1.091949973802686e-06 -0.0727894395778658 +0.6083999999999999 0.6572614776566865 0.6572596567537907 1.0856569614969835e-06 -0.07279658128177223 +0.6085 0.6572750680423964 0.65727322473995 1.0791401348908547e-06 -0.07280372140629499 +0.6086 0.6572886550777176 0.6572867895089608 1.0724008067120039e-06 -0.07281085995162853 +0.6087 0.6573022387610092 0.6573003510636105 1.0654403339027674e-06 -0.07281799691796727 +0.6088000000000001 0.6573158190906442 0.6573139094066727 1.0582601174258244e-06 -0.07282513230550576 +0.6089 0.65732939606501 0.6573274645409068 1.0508616020976635e-06 -0.07283226611443859 +0.609 0.6573429696825082 0.6573410164690578 1.0432462762555161e-06 -0.07283939834496046 +0.6091 0.6573565399415559 0.6573545651938557 1.0354156716463336e-06 -0.07284652899726606 +0.6092000000000001 0.6573701068405855 0.6573681107180145 1.0273713627884096e-06 -0.07285365807155013 +0.6093000000000001 0.6573836703780451 0.6573816530442325 1.0191149668603572e-06 -0.07286078556800747 +0.6093999999999999 0.6573972305524001 0.6573951921751919 1.0106481433957981e-06 -0.07286791148683304 +0.6095 0.657410787362132 0.6574087281135579 1.0019725937004953e-06 -0.0728750358282218 +0.6096 0.6574243408057394 0.6574222608619789 9.930900609356197e-07 -0.07288215859236875 +0.6097 0.6574378908817391 0.6574357904230849 9.840023293961053e-07 -0.07288927977946895 +0.6098000000000001 0.6574514375886651 0.6574493167994884 9.74711224399627e-07 -0.07289639938971744 +0.6099 0.6574649809250709 0.6574628399937836 9.652186117314887e-07 -0.07290351742330956 +0.61 0.657478520889528 0.6574763600085458 9.555263975058459e-07 -0.07291063388044045 +0.6101 0.6574920574806278 0.6574898768463306 9.456365275550827e-07 -0.07291774876130547 +0.6102000000000001 0.6575055906969808 0.6575033905096748 9.355509870412337e-07 -0.07292486206609997 +0.6103000000000001 0.6575191205372177 0.6575169010010946 9.252718003449623e-07 -0.07293197379501935 +0.6103999999999999 0.65753264699999 0.6575304083230862 9.148010303161591e-07 -0.07293908394825918 +0.6105 0.6575461700839698 0.6575439124781245 9.041407781074096e-07 -0.07294619252601493 +0.6106 0.65755968978785 0.6575574134686634 8.932931825911261e-07 -0.0729532995284822 +0.6107 0.6575732061103454 0.6575709112971353 8.822604202485262e-07 -0.07296040495585664 +0.6108000000000001 0.6575867190501933 0.657584405965951 8.710447041426761e-07 -0.07296750880833403 +0.6109 0.6576002286061522 0.6575978974774986 8.596482840850239e-07 -0.07297461108611007 +0.611 0.6576137347770038 0.6576113858341437 8.480734458304884e-07 -0.07298171178938061 +0.6111 0.6576272375615535 0.6576248710382289 8.363225107443917e-07 -0.07298881091834158 +0.6112000000000001 0.6576407369586291 0.6576383530920735 8.243978352195924e-07 -0.07299590847318892 +0.6113000000000001 0.6576542329670826 0.6576518319979731 8.123018103711743e-07 -0.07300300445411866 +0.6113999999999999 0.6576677255857897 0.657665307758199 8.000368615368458e-07 -0.07301009886132678 +0.6115 0.6576812148136513 0.6576787803749986 7.876054478606065e-07 -0.07301719169500955 +0.6116 0.6576947006495923 0.6576922498505939 7.750100614045685e-07 -0.07302428295536303 +0.6117 0.6577081830925632 0.6577057161871824 7.622532270795679e-07 -0.07303137264258357 +0.6118000000000001 0.6577216621415394 0.6577191793869361 7.493375020484194e-07 -0.07303846075686736 +0.6119 0.6577351377955223 0.6577326394520009 7.362654751014164e-07 -0.07304554729841083 +0.612 0.6577486100535395 0.6577460963844972 7.230397662538746e-07 -0.07305263226741035 +0.6121 0.6577620789146448 0.657759550186519 7.096630261493875e-07 -0.07305971566406246 +0.6122000000000001 0.6577755443779187 0.6577730008601335 6.961379355741038e-07 -0.07306679748856368 +0.6123000000000001 0.6577890064424686 0.6577864484073808 6.824672048322267e-07 -0.07307387774111056 +0.6123999999999999 0.6578024651074292 0.6577998928302741 6.686535733851917e-07 -0.07308095642189978 +0.6125 0.6578159203719629 0.6578133341307989 6.546998090745104e-07 -0.07308803353112805 +0.6126 0.6578293722352594 0.6578267723109132 6.406087077193146e-07 -0.07309510906899212 +0.6127 0.657842820696537 0.6578402073725464 6.263830926028779e-07 -0.07310218303568879 +0.6128000000000001 0.6578562657550421 0.6578536393176 6.120258137509715e-07 -0.07310925543141493 +0.6129 0.6578697074100501 0.6578670681479468 5.975397474877742e-07 -0.07311632625636753 +0.613 0.657883145660865 0.6578804938654306 5.829277958113721e-07 -0.0731233955107436 +0.6131 0.65789658050682 0.6578939164718661 5.681928858386476e-07 -0.0731304631947401 +0.6132000000000001 0.6579100119472776 0.6579073359690387 5.533379691807783e-07 -0.0731375293085542 +0.6133000000000001 0.6579234399816304 0.6579207523587042 5.383660213603703e-07 -0.0731445938523831 +0.6134 0.6579368646093005 0.6579341656425886 5.232800412563465e-07 -0.07315165682642402 +0.6135 0.6579502858297396 0.6579475758223874 5.080830504794465e-07 -0.07315871823087414 +0.6136 0.6579637036424308 0.6579609828997666 4.92778092775481e-07 -0.07316577806593089 +0.6137 0.6579771180468874 0.6579743868763608 4.773682333730767e-07 -0.07317283633179165 +0.6138000000000001 0.6579905290426529 0.6579877877537743 4.6185655847019724e-07 -0.0731798930286539 +0.6139 0.6580039366293023 0.6580011855335802 4.4624617449862125e-07 -0.07318694815671505 +0.614 0.6580173408064417 0.6580145802173212 4.3054020759658584e-07 -0.07319400171617277 +0.6141 0.6580307415737089 0.6580279718065077 4.1474180295653085e-07 -0.07320105370722467 +0.6142000000000001 0.6580441389307722 0.658041360302619 3.9885412411733157e-07 -0.07320810413006837 +0.6143000000000001 0.658057532877333 0.6580547457071027 3.8288035243694285e-07 -0.07321515298490167 +0.6144000000000001 0.6580709234131237 0.6580681280213745 3.66823686509532e-07 -0.07322220027192237 +0.6145 0.6580843105379088 0.6580815072468179 3.506873413536282e-07 -0.07322924599132828 +0.6146 0.6580976942514858 0.6580948833847843 3.3447454782231656e-07 -0.07323629014331733 +0.6147 0.6581110745536836 0.6581082564365925 3.1818855206200425e-07 -0.07324333272808745 +0.6148 0.6581244514443645 0.6581216264035296 3.0183261478383683e-07 -0.07325037374583669 +0.6149000000000001 0.6581378249234228 0.6581349932868485 2.854100105281754e-07 -0.07325741319676311 +0.615 0.6581511949907863 0.658148357087771 2.6892402720662956e-07 -0.07326445108106487 +0.6151 0.6581645616464151 0.6581617178074849 2.5237796528326806e-07 -0.07327148739894017 +0.6152000000000001 0.658177924890303 0.6581750754471452 2.35775137163996e-07 -0.07327852215058724 +0.6153000000000001 0.6581912847224768 0.6581884300078735 2.191188665651156e-07 -0.07328555533620437 +0.6154000000000001 0.6582046411429961 0.6582017814907589 2.0241248779861998e-07 -0.07329258695598993 +0.6155 0.6582179941519547 0.6582151298968559 1.856593451268762e-07 -0.07329961701014234 +0.6156 0.6582313437494793 0.6582284752271863 1.6886279208955246e-07 -0.07330664549886004 +0.6157 0.6582446899357308 0.6582418174827385 1.5202619087217872e-07 -0.07331367242234159 +0.6158 0.6582580327109032 0.6582551566644668 1.3515291154980735e-07 -0.0733206977807856 +0.6159000000000001 0.6582713720752245 0.6582684927732918 1.182463314902682e-07 -0.07332772157439064 +0.616 0.6582847080289562 0.6582818258101003 1.0130983463599308e-07 -0.07333474380335545 +0.6161 0.6582980405723946 0.6582951557757454 8.434681085869866e-08 -0.07334176446787875 +0.6162000000000001 0.6583113697058692 0.6583084826710464 6.736065523427204e-08 -0.07334878356815942 +0.6163000000000001 0.6583246954297435 0.6583218064967882 5.035476739745359e-08 -0.07335580110439625 +0.6164000000000001 0.6583380177444154 0.6583351272537217 3.333255086529485e-08 -0.07336281707678816 +0.6165 0.6583513366503165 0.6583484449425641 1.6297412329391303e-08 -0.07336983148553415 +0.6166 0.6583646521479131 0.6583617595639983 -7.472389911694632e-10 -0.07337684433083326 +0.6167 0.6583779642377048 0.6583750711186733 -1.779799207839161e-08 -0.07338385561288456 +0.6168 0.6583912729202261 0.6583883796072036 -3.485143475808611e-08 -0.07339086533188721 +0.6169000000000001 0.6584045781960453 0.6584016850301699 -5.190415439441064e-08 -0.0733978734880404 +0.617 0.6584178800657647 0.6584149873881185 -6.895273858180742e-08 -0.07340488008154336 +0.6171 0.6584311785300211 0.6584282866815618 -8.599377582414747e-08 -0.07341188511259542 +0.6172000000000001 0.6584444735894853 0.6584415829109782 -1.0302385621517585e-07 -0.07341888858139593 +0.6173000000000001 0.6584577652448622 0.6584548760768114 -1.20039572124378e-07 -0.07342589048814432 +0.6174000000000001 0.6584710534968907 0.6584681661794718 -1.3703751887417237e-07 -0.07343289083304004 +0.6175 0.658484338346344 0.6584814532193349 -1.5401429543510092e-07 -0.07343988961628266 +0.6176 0.6584976197940291 0.658494737196743 -1.7096650509196287e-07 -0.07344688683807171 +0.6177 0.6585108978407872 0.6585080181120041 -1.8789075612729578e-07 -0.07345388249860689 +0.6178 0.658524172487493 0.6585212959653923 -2.047836625135302e-07 -0.07346087659808782 +0.6179000000000001 0.6585374437350556 0.6585345707571478 -2.216418445721846e-07 -0.07346786913671433 +0.618 0.6585507115844177 0.6585478424874772 -2.3846192967122426e-07 -0.07347486011468618 +0.6181 0.6585639760365555 0.6585611111565532 -2.552405528738477e-07 -0.0734818495322032 +0.6182000000000001 0.658577237092479 0.6585743767645154 -2.71974357653193e-07 -0.07348883738946538 +0.6183000000000001 0.6585904947532318 0.6585876393114687 -2.886599965445935e-07 -0.07349582368667261 +0.6184000000000001 0.658603749019891 0.6586008987974855 -3.0529413174579245e-07 -0.07350280842402494 +0.6185 0.6586169998935669 0.6586141552226052 -3.218734359530795e-07 -0.07350979160172247 +0.6186 0.6586302473754034 0.6586274085868328 -3.3839459285395224e-07 -0.07351677321996529 +0.6187 0.6586434914665771 0.6586406588901412 -3.5485429792508905e-07 -0.07352375327895365 +0.6188 0.6586567321682978 0.6586539061324697 -3.7124925895970495e-07 -0.07353073177888775 +0.6189000000000001 0.6586699694818081 0.6586671503137247 -3.8757619691409673e-07 -0.07353770871996786 +0.619 0.6586832034083839 0.6586803914337804 -4.038318463309154e-07 -0.07354468410239438 +0.6191 0.6586964339493329 0.6586936294924779 -4.200129561926502e-07 -0.07355165792636767 +0.6192000000000001 0.6587096611059959 0.6587068644896259 -4.3611629049755685e-07 -0.07355863019208823 +0.6193000000000001 0.658722884879746 0.658720096425001 -4.521386288633411e-07 -0.07356560089975654 +0.6194000000000001 0.6587361052719879 0.6587333252983476 -4.6807676727655956e-07 -0.07357257004957318 +0.6195 0.6587493222841588 0.6587465511093782 -4.839275186685477e-07 -0.07357953764173877 +0.6196 0.6587625359177276 0.658759773857773 -4.996877135260425e-07 -0.073586503676454 +0.6197 0.6587757461741949 0.6587729935431813 -5.153542005226219e-07 -0.07359346815391958 +0.6198 0.6587889530550926 0.6587862101652205 -5.309238473860667e-07 -0.07360043107433631 +0.6199000000000001 0.6588021565619839 0.6587994237234766 -5.463935411065268e-07 -0.07360739243790497 +0.62 0.6588153566964634 0.6588126342175051 -5.617601889634782e-07 -0.07361435224482656 +0.6201 0.6588285534601561 0.6588258416468304 -5.770207187894005e-07 -0.07362131049530195 +0.6202000000000001 0.6588417468547179 0.6588390460109459 -5.921720799273444e-07 -0.07362826718953214 +0.6203000000000001 0.6588549368818353 0.6588522473093149 -6.072112436611432e-07 -0.07363522232771819 +0.6204000000000001 0.6588681235432244 0.6588654455413708 -6.221352037288908e-07 -0.07364217591006124 +0.6205 0.6588813068406318 0.6588786407065164 -6.369409771694867e-07 -0.07364912793676236 +0.6206 0.6588944867758343 0.658891832804125 -6.516256047806035e-07 -0.07365607840802284 +0.6207 0.658907663350637 0.6589050218335407 -6.661861516737977e-07 -0.07366302732404394 +0.6208 0.6589208365668755 0.6589182077940782 -6.80619707871255e-07 -0.07366997468502698 +0.6209000000000001 0.6589340064264136 0.6589313906850227 -6.949233890690687e-07 -0.07367692049117329 +0.621 0.658947172931144 0.6589445705056316 -7.090943369564284e-07 -0.07368386474268436 +0.6211 0.6589603360829882 0.6589577472551331 -7.231297200066544e-07 -0.07369080743976163 +0.6212000000000001 0.6589734958838958 0.6589709209327274 -7.370267338796532e-07 -0.07369774858260665 +0.6213000000000001 0.6589866523358439 0.6589840915375866 -7.507826021435626e-07 -0.07370468817142099 +0.6214000000000001 0.6589998054408379 0.6589972590688555 -7.643945765939408e-07 -0.0737116262064063 +0.6215 0.6590129552009104 0.6590104235256514 -7.778599381280671e-07 -0.07371856268776425 +0.6216 0.6590261016181208 0.6590235849070645 -7.911759970363752e-07 -0.0737254976156966 +0.6217 0.6590392446945558 0.6590367432121579 -8.043400936685874e-07 -0.0737324309904052 +0.6218 0.659052384432328 0.6590498984399689 -8.173495988084145e-07 -0.07373936281209181 +0.6219000000000001 0.6590655208335767 0.6590630505895079 -8.302019144784678e-07 -0.07374629308095841 +0.622 0.6590786539004668 0.6590761996597603 -8.428944742039368e-07 -0.07375322179720695 +0.6221 0.6590917836351888 0.659089345649685 -8.554247436648454e-07 -0.07376014896103941 +0.6222000000000001 0.6591049100399583 0.6591024885582166 -8.677902211401411e-07 -0.07376707457265788 +0.6223000000000001 0.6591180331170159 0.6591156283842642 -8.79988438090562e-07 -0.07377399863226446 +0.6224000000000001 0.6591311528686268 0.6591287651267126 -8.920169595472149e-07 -0.0737809211400613 +0.6225 0.6591442692970804 0.6591418987844222 -9.038733846944424e-07 -0.07378784209625062 +0.6226 0.6591573824046898 0.65915502935623 -9.155553472028899e-07 -0.07379476150103478 +0.6227 0.659170492193792 0.6591681568409489 -9.27060515965028e-07 -0.073801679354616 +0.6228 0.6591835986667469 0.6591812812373692 -9.383865952894421e-07 -0.07380859565719673 +0.6229000000000001 0.6591967018259371 0.6591944025442577 -9.495313255947213e-07 -0.07381551040897934 +0.623 0.6592098016737684 0.6592075207603595 -9.6049248371477e-07 -0.0738224236101664 +0.6231 0.6592228982126673 0.659220635884397 -9.712678832873856e-07 -0.07382933526096036 +0.6232000000000001 0.6592359914450834 0.6592337479150718 -9.81855375420393e-07 -0.07383624536156384 +0.6233000000000001 0.6592490813734868 0.6592468568510632 -9.92252848996955e-07 -0.07384315391217951 +0.6234000000000001 0.6592621680003687 0.6592599626910297 -1.0024582309531294e-06 -0.07385006091300998 +0.6235 0.6592752513282414 0.6592730654336099 -1.0124694869162454e-06 -0.07385696636425808 +0.6236 0.6592883313596365 0.6592861650774213 -1.02228462167675e-06 -0.07386387026612654 +0.6237 0.6593014080971062 0.6592992616210628 -1.031901679215963e-06 -0.07387077261881825 +0.6238 0.6593144815432219 0.6593123550631127 -1.0413187434832327e-06 -0.07387767342253614 +0.6239000000000001 0.6593275517005734 0.659325445402131 -1.0505339386179813e-06 -0.07388457267748309 +0.624 0.6593406185717698 0.6593385326366593 -1.0595454291717488e-06 -0.07389147038386218 +0.6241 0.6593536821594385 0.6593516167652202 -1.068351420857594e-06 -0.07389836654187641 +0.6242000000000001 0.6593667424662237 0.6593646977863195 -1.0769501605500942e-06 -0.07390526115172892 +0.6243000000000001 0.6593797994947876 0.6593777756984448 -1.085339936979235e-06 -0.07391215421362282 +0.6244000000000001 0.6593928532478099 0.6593908505000674 -1.0935190805916317e-06 -0.07391904572776138 +0.6245 0.6594059037279856 0.659403922189642 -1.1014859644942199e-06 -0.07392593569434786 +0.6246 0.6594189509380266 0.6594169907656071 -1.1092390041766986e-06 -0.07393282411358554 +0.6247 0.6594319948806601 0.6594300562263855 -1.1167766582609318e-06 -0.0739397109856778 +0.6248 0.659445035558629 0.6594431185703848 -1.1240974286397254e-06 -0.0739465963108281 +0.6249000000000001 0.6594580729746904 0.6594561777959979 -1.1311998608376506e-06 -0.07395348008923985 +0.625 0.659471107131616 0.6594692339016033 -1.1380825442053322e-06 -0.07396036232111657 +0.6251 0.6594841380321914 0.6594822868855656 -1.1447441123357827e-06 -0.07396724300666184 +0.6252000000000001 0.6594971656792159 0.6594953367462361 -1.1511832432309355e-06 -0.07397412214607928 +0.6253000000000001 0.6595101900755014 0.6595083834819528 -1.1573986596069563e-06 -0.07398099973957258 +0.6254000000000001 0.6595232112238727 0.6595214270910416 -1.1633891291162879e-06 -0.07398787578734545 +0.6255 0.6595362291271665 0.6595344675718158 -1.1691534647084723e-06 -0.07399475028960166 +0.6256 0.6595492437882313 0.6595475049225772 -1.1746905247689288e-06 -0.07400162324654506 +0.6257 0.6595622552099268 0.6595605391416166 -1.179999213313243e-06 -0.07400849465837955 +0.6258 0.6595752633951235 0.6595735702272141 -1.1850784802924785e-06 -0.07401536452530903 +0.6259000000000001 0.6595882683467018 0.6595865981776388 -1.1899273220650208e-06 -0.07402223284753746 +0.626 0.6596012700675525 0.6595996229911509 -1.1945447808414666e-06 -0.07402909962526891 +0.6261 0.6596142685605755 0.6596126446660009 -1.1989299455172908e-06 -0.07403596485870743 +0.6262000000000001 0.6596272638286795 0.6596256632004303 -1.203081951756113e-06 -0.07404282854805717 +0.6263000000000001 0.6596402558747814 0.6596386785926722 -1.2069999821562316e-06 -0.0740496906935223 +0.6264000000000001 0.6596532447018066 0.659651690840952 -1.2106832662506228e-06 -0.07405655129530704 +0.6265 0.6596662303126879 0.6596646999434874 -1.2141310807289862e-06 -0.0740634103536157 +0.6266 0.6596792127103646 0.6596777058984893 -1.2173427497430556e-06 -0.07407026786865262 +0.6267 0.6596921918977832 0.6596907087041618 -1.2203176447955766e-06 -0.07407712384062218 +0.6268 0.6597051678778956 0.659703708358703 -1.2230551851011295e-06 -0.07408397826972878 +0.6269000000000001 0.6597181406536597 0.6597167048603059 -1.2255548373918401e-06 -0.07409083115617697 +0.627 0.6597311102280385 0.6597296982071579 -1.2278161166112689e-06 -0.07409768250017128 +0.6271 0.6597440766039995 0.659742688397442 -1.2298385852482774e-06 -0.07410453230191627 +0.6272000000000001 0.659757039784514 0.6597556754293368 -1.2316218540586732e-06 -0.07411138056161655 +0.6273000000000001 0.6597699997725572 0.6597686593010175 -1.233165581732143e-06 -0.0741182272794768 +0.6274000000000001 0.6597829565711082 0.6597816400106566 -1.2344694750865415e-06 -0.07412507245570185 +0.6275 0.6597959101831479 0.6597946175564229 -1.235533289428714e-06 -0.07413191609049644 +0.6276 0.6598088606116592 0.6598075919364839 -1.2363568279993853e-06 -0.07413875818406536 +0.6277 0.6598218078596274 0.6598205631490048 -1.2369399426392924e-06 -0.07414559873661353 +0.6278 0.6598347519300387 0.6598335311921499 -1.237282533317341e-06 -0.07415243774834589 +0.6279000000000001 0.6598476928258805 0.6598464960640831 -1.237384548491427e-06 -0.07415927521946745 +0.628 0.6598606305501395 0.6598594577629668 -1.2372459848863926e-06 -0.07416611115018319 +0.6281 0.6598735651058035 0.6598724162869649 -1.2368668877160705e-06 -0.07417294554069824 +0.6282000000000001 0.6598864964958586 0.6598853716342414 -1.2362473504889948e-06 -0.07417977839121775 +0.6283000000000001 0.6598994247232897 0.6598983238029619 -1.235387514980646e-06 -0.07418660970194689 +0.6284000000000001 0.6599123497910808 0.659911272791293 -1.2342875715387613e-06 -0.07419343947309089 +0.6285 0.6599252717022126 0.6599242185974044 -1.2329477585004689e-06 -0.07420026770485498 +0.6286 0.6599381904596645 0.6599371612194678 -1.2313683625253535e-06 -0.07420709439744462 +0.6287 0.6599511060664114 0.6599501006556578 -1.229549718623213e-06 -0.07421391955106509 +0.6288 0.6599640185254256 0.6599630369041537 -1.2274922096822127e-06 -0.07422074316592185 +0.6289000000000001 0.6599769278396751 0.6599759699631378 -1.2251962666631755e-06 -0.07422756524222043 +0.629 0.6599898340121229 0.6599888998307974 -1.2226623686828475e-06 -0.07423438578016632 +0.6291 0.6600027370457273 0.6600018265053247 -1.219891042403276e-06 -0.07424120477996506 +0.6292000000000001 0.6600156369434411 0.660014749984918 -1.2168828624481431e-06 -0.07424802224182236 +0.6293000000000001 0.6600285337082106 0.6600276702677811 -1.2136384509309206e-06 -0.07425483816594385 +0.6294000000000001 0.6600414273429763 0.6600405873521242 -1.2101584775658925e-06 -0.07426165255253525 +0.6295 0.6600543178506717 0.6600535012361648 -1.206443659335088e-06 -0.07426846540180243 +0.6296 0.6600672052342222 0.6600664119181279 -1.2024947604605263e-06 -0.07427527671395114 +0.6297 0.6600800894965457 0.660079319396246 -1.1983125923487048e-06 -0.07428208648918727 +0.6298 0.6600929706405518 0.6600922236687605 -1.1938980132297772e-06 -0.07428889472771677 +0.6299000000000001 0.6601058486691409 0.6601051247339214 -1.1892519281297975e-06 -0.0742957014297456 +0.63 0.6601187235852044 0.6601180225899879 -1.184375288509898e-06 -0.07430250659547978 +0.6301 0.6601315953916236 0.6601309172352288 -1.179269092238533e-06 -0.07430931022512532 +0.6302000000000001 0.6601444640912703 0.6601438086679242 -1.173934383424946e-06 -0.07431611231888846 +0.6303000000000001 0.6601573296870042 0.6601566968863638 -1.1683722521138584e-06 -0.07432291287697528 +0.6304000000000001 0.6601701921816752 0.660169581888849 -1.162583833952402e-06 -0.07432971189959202 +0.6305 0.6601830515781208 0.6601824636736926 -1.1565703102178748e-06 -0.07433650938694496 +0.6306 0.6601959078791668 0.6601953422392199 -1.150332907401408e-06 -0.07434330533924043 +0.6307 0.6602087610876259 0.6602082175837682 -1.1438728969859202e-06 -0.07435009975668472 +0.6308 0.6602216112062984 0.6602210897056884 -1.1371915952795852e-06 -0.07435689263948429 +0.6309000000000001 0.6602344582379708 0.6602339586033443 -1.1302903630272532e-06 -0.07436368398784561 +0.631 0.6602473021854158 0.660246824275114 -1.1231706053549395e-06 -0.07437047380197519 +0.6311 0.6602601430513922 0.6602596867193897 -1.115833771131447e-06 -0.0743772620820796 +0.6312000000000001 0.6602729808386434 0.6602725459345784 -1.108281352996121e-06 -0.07438404882836545 +0.6313000000000001 0.6602858155498975 0.6602854019191025 -1.1005148868037384e-06 -0.07439083404103934 +0.6314000000000001 0.6602986471878678 0.6602982546713996 -1.0925359515967514e-06 -0.074397617720308 +0.6315 0.6603114757552504 0.6603111041899241 -1.0843461690501766e-06 -0.07440439986637819 +0.6316 0.6603243012547261 0.6603239504731462 -1.0759472033328166e-06 -0.07441118047945672 +0.6317 0.6603371236889578 0.6603367935195532 -1.067340760552149e-06 -0.07441795955975042 +0.6318 0.6603499430605917 0.6603496333276502 -1.0585285886155482e-06 -0.07442473710746618 +0.6319000000000001 0.6603627593722556 0.6603624698959591 -1.0495124767861963e-06 -0.07443151312281092 +0.632 0.6603755726265598 0.6603753032230213 -1.040294255294505e-06 -0.07443828760599165 +0.6321 0.6603883828260956 0.660388133307396 -1.0308757950883152e-06 -0.07444506055721546 +0.6322000000000001 0.6604011899734354 0.6604009601476614 -1.0212590072500305e-06 -0.07445183197668942 +0.6323000000000001 0.6604139940711322 0.6604137837424147 -1.0114458428300832e-06 -0.07445860186462058 +0.6324000000000001 0.6604267951217191 0.6604266040902738 -1.001438292430601e-06 -0.07446537022121617 +0.6325 0.6604395931277094 0.6604394211898763 -9.912383854282503e-07 -0.07447213704668341 +0.6326 0.660452388091595 0.6604522350398805 -9.808481902240374e-07 -0.0744789023412296 +0.6327 0.6604651800158479 0.6604650456389656 -9.702698134383958e-07 -0.07448566610506203 +0.6328 0.6604779689029181 0.6604778529858322 -9.595053992728086e-07 -0.07449242833838811 +0.6329000000000001 0.6604907547552339 0.6604906570792022 -9.485571295375639e-07 -0.07449918904141518 +0.633 0.6605035375752017 0.6605034579178204 -9.374272229578651e-07 -0.07450594821435082 +0.6331 0.6605163173652054 0.6605162555004533 -9.26117934674231e-07 -0.07451270585740245 +0.6332000000000001 0.6605290941276063 0.6605290498258913 -9.146315560482066e-07 -0.07451946197077775 +0.6333000000000001 0.6605418678647414 0.6605418408929464 -9.029704139129624e-07 -0.07452621655468417 +0.6334000000000001 0.6605546385789256 0.6605546287004557 -8.911368703234945e-07 -0.07453296960932947 +0.6335 0.660567406272449 0.660567413247279 -8.791333219737574e-07 -0.07453972113492131 +0.6336 0.6605801709475779 0.6605801945323013 -8.669621995999188e-07 -0.07454647113166744 +0.6337 0.6605929326065536 0.6605929725544315 -8.546259677444379e-07 -0.07455321959977568 +0.6338 0.6606056912515931 0.6606057473126037 -8.421271241038086e-07 -0.07455996653945385 +0.6339000000000001 0.6606184468848875 0.6606185188057774 -8.294681989873265e-07 -0.07456671195090989 +0.634 0.6606311995086024 0.6606312870329373 -8.166517549978991e-07 -0.07457345583435164 +0.6341 0.6606439491248779 0.6606440519930944 -8.036803863104014e-07 -0.07458019818998717 +0.6342000000000001 0.6606566957358275 0.6606568136852855 -7.905567182553419e-07 -0.07458693901802443 +0.6343000000000001 0.6606694393435385 0.6606695721085742 -7.772834067359957e-07 -0.07459367831867157 +0.6344000000000001 0.6606821799500712 0.6606823272620512 -7.638631377149263e-07 -0.0746004160921367 +0.6345 0.660694917557459 0.6606950791448337 -7.502986266727518e-07 -0.07460715233862801 +0.6346 0.6607076521677072 0.6607078277560667 -7.365926181779336e-07 -0.07461388705835366 +0.6347 0.6607203837827942 0.6607205730949227 -7.227478850818647e-07 -0.07462062025152193 +0.6348 0.6607331124046698 0.6607333151606023 -7.087672281719248e-07 -0.07462735191834113 +0.6349000000000001 0.6607458380352558 0.6607460539523348 -6.946534755053468e-07 -0.07463408205901965 +0.635 0.6607585606764456 0.6607587894693772 -6.804094818402273e-07 -0.07464081067376585 +0.6351 0.6607712803301036 0.6607715217110159 -6.660381280942929e-07 -0.07464753776278821 +0.6352000000000001 0.6607839969980649 0.6607842506765662 -6.515423208591775e-07 -0.0746542633262952 +0.6353000000000001 0.660796710682136 0.6607969763653729 -6.369249915816333e-07 -0.07466098736449542 +0.6354000000000001 0.660809421384093 0.6608096987768101 -6.221890961888299e-07 -0.0746677098775974 +0.6355 0.6608221291056824 0.6608224179102817 -6.073376143250764e-07 -0.07467443086580974 +0.6356 0.6608348338486211 0.660835133765222 -5.92373548907732e-07 -0.0746811503293412 +0.6357 0.6608475356145952 0.6608478463410952 -5.772999253639277e-07 -0.07468786826840047 +0.6358 0.6608602344052608 0.6608605556373963 -5.621197911864773e-07 -0.07469458468319636 +0.6359000000000001 0.6608729302222425 0.6608732616536507 -5.468362151705985e-07 -0.0747012995739376 +0.636 0.6608856230671344 0.6608859643894149 -5.314522869698246e-07 -0.0747080129408331 +0.6361 0.6608983129415 0.6608986638442766 -5.159711161939473e-07 -0.07471472478409179 +0.6362000000000001 0.6609109998468707 0.6609113600178549 -5.00395831978806e-07 -0.07472143510392262 +0.6363000000000001 0.6609236837847468 0.6609240529098002 -4.847295824728093e-07 -0.07472814390053456 +0.6364000000000001 0.6609363647565963 0.6609367425197945 -4.6897553389324553e-07 -0.07473485117413668 +0.6365 0.660949042763856 0.6609494288475525 -4.53136870123827e-07 -0.0747415569249381 +0.6366 0.6609617178079303 0.6609621118928201 -4.372167919514114e-07 -0.07474826115314795 +0.6367 0.6609743898901912 0.6609747916553756 -4.212185165108906e-07 -0.07475496385897537 +0.6368 0.6609870590119787 0.6609874681350301 -4.051452765496677e-07 -0.07476166504262963 +0.6369000000000001 0.6609997251745996 0.6610001413316267 -3.8900031987948447e-07 -0.07476836470431995 +0.637 0.6610123883793289 0.6610128112450416 -3.7278690858538743e-07 -0.07477506284425571 +0.6371 0.661025048627408 0.6610254778751838 -3.565083184081663e-07 -0.07478175946264624 +0.6372000000000001 0.6610377059200456 0.6610381412219953 -3.401678382447537e-07 -0.07478845455970096 +0.6373000000000001 0.6610503602584175 0.661050801285451 -3.2376876921841324e-07 -0.07479514813562937 +0.6374000000000001 0.6610630116436657 0.661063458065559 -3.073144242138337e-07 -0.07480184019064091 +0.6375 0.6610756600768994 0.6610761115623611 -2.908081271346674e-07 -0.07480853072494519 +0.6376000000000001 0.6610883055591943 0.6610887617759319 -2.742532122235186e-07 -0.07481521973875167 +0.6377 0.661100948091592 0.6611014087063806 -2.576530234235652e-07 -0.07482190723227015 +0.6378 0.6611135876751011 0.6611140523538489 -2.4101091366385274e-07 -0.07482859320571021 +0.6379000000000001 0.661126224310696 0.6611266927185131 -2.243302442070383e-07 -0.0748352776592816 +0.638 0.6611388579993177 0.6611393298005827 -2.0761438397631782e-07 -0.0748419605931941 +0.6381 0.661151488741873 0.6611519636003015 -1.9086670886153678e-07 -0.07484864200765755 +0.6382000000000001 0.661164116539235 0.6611645941179471 -1.740906010391785e-07 -0.07485532190288179 +0.6383000000000001 0.6611767413922425 0.661177221353831 -1.5728944828194424e-07 -0.07486200027907668 +0.6384000000000001 0.6611893633017003 0.6611898453082988 -1.4046664330302772e-07 -0.07486867713645227 +0.6385 0.6612019822683792 0.6612024659817304 -1.236255830240618e-07 -0.07487535247521845 +0.6386000000000001 0.6612145982930158 0.6612150833745395 -1.0676966794367915e-07 -0.07488202629558531 +0.6387 0.6612272113763124 0.6612276974871745 -8.99023014158673e-08 -0.07488869859776291 +0.6388 0.6612398215189371 0.6612403083201175 -7.302688895954867e-08 -0.07489536938196142 +0.6389000000000001 0.6612524287215242 0.6612529158738852 -5.6146837588109955e-08 -0.074902038648391 +0.639 0.6612650329846733 0.6612655201490285 -3.92655551170306e-08 -0.07490870639726192 +0.6391 0.6612776343089499 0.661278121146132 -2.2386449473896577e-08 -0.07491537262878435 +0.6392 0.6612902326948848 0.6612907188658154 -5.5129280055951635e-09 -0.07492203734316864 +0.6393000000000001 0.6613028281429753 0.6613033133087316 1.1351603205166094e-08 -0.07492870054062511 +0.6394000000000001 0.661315420653684 0.6613159044755688 2.82037400274604e-08 -0.07493536222136418 +0.6395 0.6613280102274396 0.6613284923670486 4.5040080973862695e-08 -0.07494202238559629 +0.6396000000000001 0.6613405968646364 0.661341076983927 6.185722788674963e-08 -0.07494868103353192 +0.6397 0.6613531805656345 0.6613536583269946 7.865178661484173e-08 -0.07495533816538157 +0.6398 0.6613657613307604 0.6613662363970754 9.542036771836848e-08 -0.07496199378135589 +0.6399000000000001 0.6613783391603059 0.6613788111950276 1.1215958712826324e-07 -0.07496864788166545 +0.64 0.6613909140545291 0.6613913827217438 1.288660668660735e-07 -0.07497530046652089 +0.6401 0.6614034860136544 0.66140395097815 1.4553643569448216e-07 -0.07498195153613293 +0.6402 0.6614160550378722 0.661416515965206 1.6216732980772752e-07 -0.07498860109071233 +0.6403000000000001 0.6614286211273389 0.661429077683906 1.7875539351161485e-07 -0.07499524913046988 +0.6404000000000001 0.6614411842821777 0.6614416361352771 1.9529727988965018e-07 -0.07500189565561645 +0.6405 0.6614537445024775 0.6614541913203804 2.1178965152468532e-07 -0.07500854066636284 +0.6406000000000001 0.6614663017882945 0.6614667432403107 2.2822918113035717e-07 -0.07501518416292002 +0.6407 0.6614788561396507 0.6614792918961956 2.446125522276299e-07 -0.07502182614549895 +0.6408 0.6614914075565355 0.6614918372891965 2.6093645982133706e-07 -0.07502846661431063 +0.6409000000000001 0.6615039560389048 0.6615043794205074 2.7719761107325436e-07 -0.07503510556956611 +0.641 0.6615165015866815 0.6615169182913561 2.9339272591966115e-07 -0.07504174301147654 +0.6411 0.6615290441997559 0.6615294539030024 3.095185378554355e-07 -0.07504837894025296 +0.6412 0.661541583877985 0.6615419862567397 3.255717945099823e-07 -0.07505501335610666 +0.6413000000000001 0.6615541206211935 0.6615545153538934 3.415492582370394e-07 -0.0750616462592488 +0.6414000000000001 0.6615666544291737 0.6615670411958215 3.574477068779558e-07 -0.07506827764989067 +0.6415 0.6615791853016856 0.6615795637839146 3.7326393444170325e-07 -0.07507490752824361 +0.6416000000000001 0.6615917132384566 0.661592083119595 3.889947516461101e-07 -0.07508153589451892 +0.6417 0.6616042382391827 0.6616045992043171 4.046369865423616e-07 -0.07508816274892802 +0.6418 0.6616167603035279 0.6616171120395675 4.201874853060339e-07 -0.0750947880916824 +0.6419000000000001 0.6616292794311243 0.6616296216268637 4.3564311269506106e-07 -0.07510141192299347 +0.642 0.661641795621573 0.6616421279677551 4.5100075291015784e-07 -0.07510803424307283 +0.6421 0.6616543088744439 0.661654631063822 4.662573100250311e-07 -0.075114655052132 +0.6422 0.6616668191892754 0.6616671309166762 4.814097086941471e-07 -0.07512127435038263 +0.6423000000000001 0.6616793265655756 0.6616796275279597 4.964548946662095e-07 -0.07512789213803636 +0.6424000000000001 0.6616918310028216 0.6616921208993456 5.113898356862157e-07 -0.0751345084153049 +0.6425 0.6617043325004606 0.661704611032537 5.262115217036234e-07 -0.07514112318240002 +0.6426000000000001 0.6617168310579089 0.661717097929267 5.40916965857674e-07 -0.07514773643953344 +0.6427 0.6617293266745539 0.6617295815912994 5.555032048382147e-07 -0.07515434818691703 +0.6428 0.6617418193497525 0.6617420620204266 5.699672995934657e-07 -0.07516095842476268 +0.6429000000000001 0.6617543090828325 0.6617545392184712 5.843063359545209e-07 -0.0751675671532823 +0.643 0.6617667958730926 0.6617670131872844 5.985174250100478e-07 -0.07517417437268781 +0.6431 0.6617792797198024 0.6617794839287467 6.125977039667108e-07 -0.0751807800831912 +0.6432 0.6617917606222028 0.6617919514447673 6.265443366348933e-07 -0.07518738428500454 +0.6433000000000001 0.6618042385795065 0.6618044157372834 6.403545139282985e-07 -0.0751939869783399 +0.6434000000000001 0.6618167135908986 0.6618168768082604 6.540254543913049e-07 -0.07520058816340947 +0.6435 0.6618291856555352 0.6618293346596915 6.675544049900006e-07 -0.0752071878404253 +0.6436000000000001 0.6618416547725459 0.6618417892935978 6.80938641514639e-07 -0.07521378600959971 +0.6437 0.6618541209410324 0.661854240712027 6.941754690653612e-07 -0.07522038267114489 +0.6438 0.6618665841600699 0.6618666889170544 7.072622227599634e-07 -0.07522697782527321 +0.6439000000000001 0.6618790444287067 0.6618791339107812 7.201962681502305e-07 -0.0752335714721969 +0.644 0.661891501745965 0.6618915756953355 7.329750017215364e-07 -0.07524016361212843 +0.6441 0.6619039561108409 0.6619040142728712 7.455958516422445e-07 -0.07524675424528017 +0.6442 0.6619164075223043 0.6619164496455676 7.58056278082897e-07 -0.07525334337186462 +0.6443000000000001 0.6619288559793006 0.6619288818156297 7.70353773715815e-07 -0.07525993099209424 +0.6444000000000001 0.6619413014807498 0.6619413107852878 7.824858643812327e-07 -0.07526651710618164 +0.6445 0.6619537440255469 0.6619537365567962 7.94450109406486e-07 -0.07527310171433936 +0.6446000000000001 0.6619661836125627 0.6619661591324343 8.062441022443911e-07 -0.07527968481678003 +0.6447 0.6619786202406442 0.6619785785145045 8.178654709589672e-07 -0.07528626641371634 +0.6448 0.6619910539086145 0.6619909947053337 8.293118784752362e-07 -0.07529284650536097 +0.6449000000000001 0.6620034846152735 0.6620034077072721 8.405810233702571e-07 -0.07529942509192672 +0.645 0.6620159123593979 0.662015817522692 8.516706402617036e-07 -0.07530600217362636 +0.6451 0.6620283371397424 0.6620282241539897 8.625785000160313e-07 -0.07531257775067275 +0.6452 0.662040758955039 0.6620406276035823 8.733024104701226e-07 -0.07531915182327878 +0.6453000000000001 0.6620531778039979 0.6620530278739096 8.838402168198645e-07 -0.07532572439165737 +0.6454000000000001 0.6620655936853076 0.6620654249674327 8.941898019532157e-07 -0.07533229545602148 +0.6455 0.6620780065976359 0.662077818886633 9.043490870330739e-07 -0.07533886501658406 +0.6456000000000001 0.66209041653963 0.6620902096340139 9.143160318303423e-07 -0.07534543307355819 +0.6457 0.6621028235099164 0.662102597212098 9.240886351125077e-07 -0.07535199962715698 +0.6458 0.6621152275071016 0.6621149816234284 9.336649350599746e-07 -0.07535856467759353 +0.6459000000000001 0.662127628529773 0.662127362870568 9.430430096268871e-07 -0.07536512822508101 +0.646 0.662140026576499 0.6621397409560978 9.522209770407297e-07 -0.0753716902698327 +0.6461 0.6621524216458283 0.6621521158826182 9.611969961631495e-07 -0.07537825081206175 +0.6462 0.6621648137362925 0.6621644876527477 9.69969266961801e-07 -0.07538480985198154 +0.6463000000000001 0.6621772028464048 0.6621768562691227 9.785360304270796e-07 -0.0753913673898053 +0.6464000000000001 0.6621895889746606 0.662189221734397 9.868955694047887e-07 -0.07539792342574647 +0.6465 0.6622019721195389 0.6622015840512419 9.950462087904288e-07 -0.0754044779600185 +0.6466000000000001 0.6622143522795017 0.6622139432223444 1.0029863157789976e-06 -0.07541103099283482 +0.6467 0.6622267294529947 0.6622262992504083 1.0107143003368346e-06 -0.0754175825244089 +0.6468 0.6622391036384481 0.6622386521381532 1.0182286155069331e-06 -0.07542413255495432 +0.6469000000000001 0.6622514748342764 0.6622510018883139 1.025527757630984e-06 -0.0754306810846846 +0.647 0.6622638430388798 0.6622633485036395 1.0326102665991765e-06 -0.0754372281138134 +0.6471 0.6622762082506434 0.6622756919868944 1.0394747263497983e-06 -0.07544377364255435 +0.6472 0.6622885704679389 0.6622880323408566 1.0461197650080134e-06 -0.07545031767112119 +0.6473000000000001 0.662300929689124 0.6623003695683178 1.0525440552744403e-06 -0.07545686019972764 +0.6474000000000001 0.6623132859125433 0.6623127036720825 1.0587463145084186e-06 -0.07546340122858744 +0.6475 0.6623256391365293 0.6623250346549681 1.0647253051720984e-06 -0.07546994075791451 +0.6476000000000001 0.6623379893594017 0.6623373625198039 1.0704798351079958e-06 -0.07547647878792263 +0.6477 0.6623503365794684 0.6623496872694314 1.0760087574557264e-06 -0.07548301531882574 +0.6478 0.6623626807950265 0.6623620089067033 1.0813109712348723e-06 -0.07548955035083782 +0.6479000000000001 0.6623750220043618 0.6623743274344824 1.0863854215670266e-06 -0.0754960838841728 +0.648 0.66238736020575 0.6623866428556429 1.0912310995925267e-06 -0.07550261591904472 +0.6481 0.6623996953974568 0.662398955173068 1.0958470428590328e-06 -0.07550914645566764 +0.6482 0.6624120275777385 0.6624112643896505 1.1002323355713273e-06 -0.07551567549425563 +0.6483000000000001 0.6624243567448427 0.6624235705082924 1.1043861087023377e-06 -0.07552220303502287 +0.6484000000000001 0.6624366828970079 0.6624358735319041 1.1083075401874254e-06 -0.07552872907818353 +0.6485 0.6624490060324653 0.662448173463404 1.1119958550909192e-06 -0.07553525362395182 +0.6486000000000001 0.6624613261494376 0.6624604703057179 1.1154503257171378e-06 -0.07554177667254201 +0.6487 0.6624736432461416 0.6624727640617787 1.1186702717214114e-06 -0.07554829822416842 +0.6488 0.6624859573207866 0.662485054734526 1.1216550604986608e-06 -0.07555481827904538 +0.6489000000000001 0.6624982683715765 0.6624973423269056 1.1244041068780852e-06 -0.07556133683738729 +0.649 0.6625105763967092 0.6625096268418682 1.1269168737892965e-06 -0.07556785389940857 +0.6491 0.6625228813943771 0.6625219082823703 1.129192871873741e-06 -0.07557436946532364 +0.6492 0.6625351833627688 0.6625341866513728 1.1312316598455219e-06 -0.07558088353534706 +0.6493000000000001 0.662547482300068 0.6625464619518411 1.1330328445469107e-06 -0.07558739610969334 +0.6494000000000001 0.6625597782044548 0.6625587341867436 1.1345960810316136e-06 -0.07559390718857706 +0.6495 0.6625720710741068 0.6625710033590524 1.1359210724537494e-06 -0.07560041677221291 +0.6496000000000001 0.6625843609071979 0.6625832694717424 1.1370075704009164e-06 -0.0756069248608155 +0.6497 0.6625966477019001 0.6625955325277897 1.1378553747276587e-06 -0.07561343145459941 +0.6498 0.6626089314563839 0.6626077925301733 1.1384643338330225e-06 -0.07561993655377952 +0.6499000000000001 0.6626212121688183 0.6626200494818733 1.1388343444662663e-06 -0.07562644015857056 +0.65 0.6626334898373718 0.66263230338587 1.138965351893395e-06 -0.07563294226918738 +0.6501 0.6626457644602124 0.6626445542451442 1.1388573497028709e-06 -0.07563944288584479 +0.6502 0.6626580360355085 0.6626568020626766 1.1385103799166352e-06 -0.07564594200875775 +0.6503000000000001 0.6626703045614288 0.6626690468414473 1.1379245332676646e-06 -0.07565243963814117 +0.6504000000000001 0.6626825700361434 0.6626812885844345 1.137099948617104e-06 -0.07565893577420992 +0.6505 0.6626948324578245 0.6626935272946157 1.1360368135926446e-06 -0.07566543041717921 +0.6506000000000001 0.6627070918246454 0.6627057629749655 1.1347353636725899e-06 -0.07567192356726393 +0.6507000000000001 0.6627193481347833 0.662717995628456 1.1331958831295452e-06 -0.07567841522467923 +0.6508 0.6627316013864174 0.6627302252580565 1.1314187044197954e-06 -0.07568490538964025 +0.6509000000000001 0.6627438515777312 0.662742451866732 1.1294042080445266e-06 -0.07569139406236214 +0.651 0.6627560987069123 0.6627546754574438 1.1271528226053373e-06 -0.07569788124306008 +0.6511 0.6627683427721525 0.6627668960331488 1.124665024804239e-06 -0.07570436693194936 +0.6512 0.6627805837716492 0.6627791135967983 1.1219413393048772e-06 -0.07571085112924525 +0.6513000000000001 0.6627928217036047 0.6627913281513385 1.1189823385937547e-06 -0.07571733383516308 +0.6514000000000001 0.6628050565662278 0.6628035396997092 1.1157886427304309e-06 -0.07572381504991821 +0.6515 0.6628172883577339 0.6628157482448437 1.112360919514055e-06 -0.07573029477372605 +0.6516000000000001 0.6628295170763447 0.6628279537896684 1.108699884039277e-06 -0.07573677300680197 +0.6517000000000001 0.6628417427202903 0.662840156337102 1.1048062989182927e-06 -0.07574324974936149 +0.6518 0.6628539652878079 0.662852355890056 1.1006809736702206e-06 -0.07574972500162017 +0.6519000000000001 0.6628661847771438 0.6628645524514324 1.0963247648043684e-06 -0.07575619876379353 +0.652 0.6628784011865526 0.6628767460241249 1.0917385758479892e-06 -0.07576267103609714 +0.6521 0.6628906145142986 0.6628889366110178 1.0869233566801473e-06 -0.07576914181874664 +0.6522 0.662902824758656 0.6629011242149853 1.0818801038925407e-06 -0.07577561111195773 +0.6523000000000001 0.6629150319179092 0.6629133088388914 1.0766098601788787e-06 -0.0757820789159461 +0.6524000000000001 0.6629272359903533 0.6629254904855892 1.0711137140573257e-06 -0.07578854523092746 +0.6525 0.6629394369742946 0.662937669157921 1.065392800037035e-06 -0.07579501005711765 +0.6526000000000001 0.6629516348680509 0.662949844858717 1.059448298201815e-06 -0.07580147339473246 +0.6527000000000001 0.6629638296699527 0.6629620175907952 1.0532814338215513e-06 -0.07580793524398775 +0.6528 0.6629760213783427 0.6629741873569611 1.0468934772689398e-06 -0.07581439560509941 +0.6529 0.6629882099915765 0.6629863541600072 1.0402857438251978e-06 -0.0758208544782834 +0.653 0.6630003955080237 0.6629985180027125 1.0334595932082191e-06 -0.0758273118637557 +0.6531 0.6630125779260674 0.6630106788878417 1.0264164294337963e-06 -0.07583376776173226 +0.6532 0.6630247572441053 0.6630228368181454 1.0191577005380648e-06 -0.0758402221724292 +0.6533000000000001 0.6630369334605499 0.6630349917963594 1.0116848981611692e-06 -0.07584667509606258 +0.6534000000000001 0.6630491065738289 0.6630471438252037 1.0039995573807303e-06 -0.0758531265328485 +0.6535 0.6630612765823856 0.6630592929073832 9.961032563787775e-07 -0.07585957648300312 +0.6536000000000001 0.6630734434846799 0.6630714390455864 9.879976160531712e-07 -0.07586602494674266 +0.6537000000000001 0.6630856072791876 0.6630835822424852 9.796842995735133e-07 -0.0758724719242834 +0.6538 0.6630977679644021 0.6630957225007343 9.711650124366589e-07 -0.07587891741584153 +0.6539 0.6631099255388342 0.6631078598229709 9.62441501717315e-07 -0.07588536142163342 +0.654 0.6631220800010118 0.6631199942118152 9.535155558459962e-07 -0.0758918039418754 +0.6541 0.6631342313494821 0.6631321256698681 9.443890043869807e-07 -0.07589824497678391 +0.6542 0.6631463795828099 0.6631442541997119 9.350637175387089e-07 -0.07590468452657524 +0.6543000000000001 0.6631585246995799 0.6631563798039105 9.255416056064281e-07 -0.07591112259146598 +0.6544000000000001 0.663170666698396 0.6631685024850077 9.158246188634145e-07 -0.07591755917167257 +0.6545 0.6631828055778816 0.6631806222455277 9.059147471623952e-07 -0.07592399426741153 +0.6546000000000001 0.6631949413366809 0.663192739087974 8.958140192971698e-07 -0.07593042787889946 +0.6547000000000001 0.6632070739734587 0.6632048530148302 8.855245025585212e-07 -0.07593686000635301 +0.6548 0.6632192034869006 0.6632169640285579 8.75048302928505e-07 -0.07594329064998875 +0.6549 0.6632313298757138 0.6632290721315981 8.643875638036924e-07 -0.07594971981002344 +0.655 0.6632434531386271 0.6632411773263692 8.535444661617042e-07 -0.07595614748667374 +0.6551 0.6632555732743916 0.6632532796152679 8.425212277562988e-07 -0.07596257368015641 +0.6552 0.6632676902817811 0.6632653790006682 8.313201028675721e-07 -0.07596899839068828 +0.6553000000000001 0.6632798041595924 0.6632774754849208 8.199433818856239e-07 -0.07597542161848617 +0.6554000000000001 0.6632919149066451 0.6632895690703535 8.083933906166685e-07 -0.0759818433637669 +0.6555 0.6633040225217829 0.6633016597592705 7.966724900748678e-07 -0.07598826362674746 +0.6556000000000001 0.6633161270038732 0.6633137475539518 7.847830757745644e-07 -0.07599468240764473 +0.6557000000000001 0.6633282283518078 0.663325832456653 7.72727577411092e-07 -0.0760010997066757 +0.6558 0.6633403265645035 0.663337914469605 7.605084582779087e-07 -0.07600751552405739 +0.6559 0.6633524216409015 0.6633499935950136 7.481282147253632e-07 -0.07601392986000685 +0.656 0.6633645135799688 0.6633620698350595 7.355893757998722e-07 -0.07602034271474116 +0.6561 0.6633766023806982 0.6633741431918975 7.2289450261942e-07 -0.07602675408847745 +0.6562 0.6633886880421079 0.6633862136676565 7.10046187762936e-07 -0.07603316398143292 +0.6563000000000001 0.6634007705632429 0.6633982812644389 6.970470550343721e-07 -0.0760395723938247 +0.6564000000000001 0.6634128499431746 0.6634103459843207 6.838997586994244e-07 -0.07604597932587007 +0.6565 0.6634249261810015 0.6634224078293505 6.70606982916544e-07 -0.07605238477778627 +0.6566000000000001 0.6634369992758491 0.66343446680155 6.571714412512142e-07 -0.07605878874979062 +0.6567000000000001 0.6634490692268704 0.6634465229029133 6.435958762457394e-07 -0.07606519124210046 +0.6568 0.6634611360332464 0.6634585761354069 6.298830587253557e-07 -0.07607159225493312 +0.6569 0.6634731996941863 0.663470626500969 6.160357872431188e-07 -0.07607799178850613 +0.657 0.6634852602089273 0.663482674001509 6.020568876080601e-07 -0.07608438984303684 +0.6571 0.6634973175767354 0.663494718638908 5.879492120802743e-07 -0.07609078641874277 +0.6572 0.6635093717969056 0.6635067604150183 5.737156390378528e-07 -0.07609718151584144 +0.6573000000000001 0.6635214228687618 0.663518799331663 5.593590722968722e-07 -0.07610357513455039 +0.6574000000000001 0.6635334707916578 0.6635308353906355 5.44882440584038e-07 -0.07610996727508726 +0.6575 0.6635455155649763 0.6635428685936997 5.302886967734066e-07 -0.07611635793766965 +0.6576000000000001 0.6635575571881307 0.6635548989425895 5.15580817442296e-07 -0.07612274712251524 +0.6577000000000001 0.6635695956605638 0.6635669264390086 5.007618021912741e-07 -0.07612913482984168 +0.6578 0.6635816309817494 0.6635789510846304 4.858346731306806e-07 -0.07613552105986675 +0.6579 0.6635936631511915 0.6635909728810977 4.7080247406183773e-07 -0.0761419058128082 +0.658 0.663605692168425 0.6636029918300222 4.5566827008847177e-07 -0.07614828908888387 +0.6581 0.6636177180330158 0.6636150079329851 4.404351468534351e-07 -0.0761546708883116 +0.6582 0.6636297407445615 0.6636270211915358 4.251062099558389e-07 -0.07616105121130927 +0.6583000000000001 0.6636417603026901 0.6636390316071923 4.0968458431267507e-07 -0.07616743005809473 +0.6584000000000001 0.6636537767070623 0.6636510391814414 3.9417341356207114e-07 -0.07617380742888603 +0.6585 0.6636657899573697 0.6636630439157376 3.785758592583788e-07 -0.07618018332390109 +0.6586000000000001 0.6636778000533363 0.6636750458115036 3.628951004974734e-07 -0.07618655774335796 +0.6587000000000001 0.6636898069947184 0.66368704487013 3.4713433305633146e-07 -0.07619293068747467 +0.6588 0.6637018107813042 0.6636990410929748 3.312967688517965e-07 -0.0761993021564693 +0.6589 0.6637138114129149 0.6637110344813637 3.1538563513566764e-07 -0.07620567215056002 +0.659 0.6637258088894036 0.6637230250365899 2.9940417409224374e-07 -0.07621204066996498 +0.6591 0.6637378032106569 0.6637350127599135 2.8335564194320595e-07 -0.07621840771490239 +0.6592 0.663749794376594 0.6637469976525617 2.67243308413323e-07 -0.07622477328559044 +0.6593000000000001 0.6637617823871671 0.6637589797157287 2.5107045602962286e-07 -0.07623113738224742 +0.6594000000000001 0.6637737672423614 0.6637709589505754 2.3484037941362557e-07 -0.07623750000509161 +0.6595 0.6637857489421957 0.6637829353582294 2.1855638470541505e-07 -0.07624386115434137 +0.6596000000000001 0.6637977274867222 0.6637949089397852 2.022217887795441e-07 -0.07625022083021507 +0.6597000000000001 0.6638097028760264 0.6638068796963035 1.8583991866216731e-07 -0.07625657903293113 +0.6598 0.6638216751102274 0.6638188476288113 1.6941411078164048e-07 -0.07626293576270797 +0.6599 0.6638336441894783 0.6638308127383018 1.529477103509591e-07 -0.07626929101976407 +0.66 0.6638456101139655 0.6638427750257347 1.3644407064611341e-07 -0.07627564480431794 +0.6601 0.6638575728839097 0.6638547344920356 1.1990655235730174e-07 -0.07628199711658812 +0.6602 0.6638695324995653 0.6638666911380962 1.0333852285340783e-07 -0.07628834795679319 +0.6603000000000001 0.6638814889612206 0.663878644964774 8.674335552627532e-08 -0.07629469732515176 +0.6604000000000001 0.6638934422691982 0.6638905959728927 7.012442913151284e-08 -0.0763010452218825 +0.6605 0.6639053924238546 0.663902544163242 5.348512704429764e-08 -0.07630739164720407 +0.6606000000000001 0.6639173394255806 0.663914489536577 3.682883660191538e-08 -0.07631373660133521 +0.6607000000000001 0.6639292832748009 0.6639264320936186 2.015894842548327e-08 -0.07632008008449467 +0.6608 0.6639412239719751 0.6639383718350538 3.478855715652318e-09 -0.07632642209690121 +0.6609 0.663953161517596 0.6639503087615352 -1.3208046457761913e-08 -0.0763327626387737 +0.661 0.6639650959121914 0.6639622428736809 -2.989836181410688e-08 -0.07633910171033093 +0.6611 0.6639770271563231 0.6639741741720749 -4.658869357464755e-08 -0.07634543931179183 +0.6612 0.6639889552505873 0.663986102657267 -6.327564514171068e-08 -0.07635177544337532 +0.6613000000000001 0.6640008801956141 0.6639980283297727 -7.995582080189828e-08 -0.07635811010530036 +0.6614000000000001 0.6640128019920682 0.664009951190073 -9.662582641217082e-08 -0.07636444329778595 +0.6615 0.6640247206406488 0.6640218712386148 -1.1328227008354508e-07 -0.07637077502105108 +0.6616000000000001 0.6640366361420883 0.664033788475811 -1.2992176288278978e-07 -0.07637710527531487 +0.6617000000000001 0.664048548497154 0.6640457029020397 -1.4654091952739923e-07 -0.07638343406079634 +0.6618 0.6640604577066471 0.6640576145176456 -1.631363590604007e-07 -0.07638976137771465 +0.6619 0.6640723637714033 0.6640695233229384 -1.7970470553990703e-07 -0.07639608722628899 +0.662 0.6640842666922917 0.6640814293181948 -1.9624258874167966e-07 -0.0764024116067385 +0.6621 0.6640961664702154 0.6640933325036567 -2.127466448252624e-07 -0.07640873451928246 +0.6622 0.6641080631061118 0.664105232879532 -2.292135170382792e-07 -0.07641505596414006 +0.6623000000000001 0.664119956600952 0.6641171304459957 -2.456398563895068e-07 -0.07642137594153066 +0.6624000000000001 0.6641318469557408 0.6641290252031883 -2.6202232232888645e-07 -0.07642769445167359 +0.6625 0.6641437341715162 0.6641409171512165 -2.7835758343447425e-07 -0.07643401149478816 +0.6626000000000001 0.6641556182493503 0.664152806290154 -2.946423180993918e-07 -0.07644032707109383 +0.6627000000000001 0.6641674991903487 0.6641646926200405 -3.108732151702043e-07 -0.07644664118081002 +0.6628000000000001 0.6641793769956499 0.6641765761408825 -3.2704697468244337e-07 -0.07645295382415616 +0.6629 0.6641912516664257 0.6641884568526534 -3.4316030847469925e-07 -0.07645926500135176 +0.663 0.6642031232038814 0.6642003347552934 -3.592099408894489e-07 -0.07646557471261639 +0.6631 0.6642149916092549 0.6642122098487095 -3.751926094322511e-07 -0.07647188295816959 +0.6632 0.6642268568838168 0.664224082132776 -3.9110506545175783e-07 -0.0764781897382309 +0.6633000000000001 0.6642387190288708 0.6642359516073344 -4.069440747850317e-07 -0.07648449505302002 +0.6634000000000001 0.6642505780457527 0.6642478182721937 -4.2270641840286283e-07 -0.07649079890275659 +0.6635 0.6642624339358312 0.6642596821271306 -4.383888930759028e-07 -0.07649710128766031 +0.6636 0.6642742867005068 0.6642715431718894 -4.5398831204079837e-07 -0.07650340220795096 +0.6637000000000001 0.6642861363412121 0.664283401406182 -4.6950150564550874e-07 -0.07650970166384818 +0.6638000000000001 0.6642979828594119 0.6642952568296893 -4.849253220085004e-07 -0.07651599965557188 +0.6639 0.664309826256602 0.6643071094420593 -5.002566276085529e-07 -0.07652229618334183 +0.664 0.6643216665343106 0.6643189592429093 -5.154923080202822e-07 -0.07652859124737793 +0.6641 0.6643335036940962 0.664330806231825 -5.306292684137404e-07 -0.0765348848479 +0.6642 0.6643453377375496 0.6643426504083612 -5.456644342760608e-07 -0.07654117698512806 +0.6643000000000001 0.6643571686662912 0.664354491772041 -5.605947520082033e-07 -0.07654746765928201 +0.6644000000000001 0.6643689964819731 0.6643663303223577 -5.754171895772098e-07 -0.07655375687058184 +0.6645 0.6643808211862775 0.664378166058774 -5.901287371268271e-07 -0.07656004461924765 +0.6646 0.6643926427809166 0.6643899989807216 -6.047264075187408e-07 -0.07656633090549947 +0.6647000000000001 0.6644044612676328 0.6644018290876026 -6.192072370819757e-07 -0.0765726157295573 +0.6648000000000001 0.6644162766481985 0.6644136563787898 -6.335682861263736e-07 -0.07657889909164138 +0.6649 0.664428088924415 0.6644254808536255 -6.478066394838278e-07 -0.07658518099197183 +0.665 0.6644398980981134 0.6644373025114233 -6.619194072160495e-07 -0.07659146143076877 +0.6651 0.6644517041711536 0.6644491213514676 -6.75903725155802e-07 -0.07659774040825247 +0.6652 0.6644635071454247 0.6644609373730144 -6.897567554620121e-07 -0.07660401792464325 +0.6653000000000001 0.6644753070228434 0.6644727505752904 -7.034756872581482e-07 -0.07661029398016134 +0.6654000000000001 0.6644871038053551 0.6644845609574946 -7.170577371734543e-07 -0.07661656857502702 +0.6655 0.6644988974949331 0.6644963685187982 -7.305001498564279e-07 -0.07662284170946068 +0.6656 0.6645106880935783 0.6645081732583442 -7.438001986270759e-07 -0.07662911338368271 +0.6657000000000001 0.6645224756033188 0.6645199751752487 -7.569551860320267e-07 -0.0766353835979135 +0.6658000000000001 0.6645342600262101 0.6645317742686004 -7.699624442192299e-07 -0.07664165235237351 +0.6659 0.6645460413643339 0.6645435705374615 -7.82819335812257e-07 -0.0766479196472832 +0.666 0.664557819619799 0.6645553639808673 -7.955232541878576e-07 -0.07665418548286312 +0.6661 0.6645695947947399 0.6645671545978276 -8.080716239616814e-07 -0.07666044985933379 +0.6662 0.6645813668913166 0.6645789423873258 -8.204619017376791e-07 -0.07666671277691581 +0.6663000000000001 0.6645931359117154 0.6645907273483199 -8.32691576510558e-07 -0.07667297423582974 +0.6664000000000001 0.664604901858147 0.664602509479743 -8.447581701376272e-07 -0.07667923423629625 +0.6665 0.6646166647328471 0.6646142887805031 -8.566592378939086e-07 -0.07668549277853604 +0.6666 0.6646284245380761 0.6646260652494838 -8.683923689301043e-07 -0.07669174986276976 +0.6667000000000001 0.6646401812761183 0.6646378388855444 -8.799551868554634e-07 -0.07669800548921818 +0.6668000000000001 0.6646519349492814 0.6646496096875205 -8.913453500986046e-07 -0.076704259658102 +0.6669 0.6646636855598975 0.6646613776542242 -9.025605525458946e-07 -0.07671051236964212 +0.667 0.6646754331103208 0.6646731427844447 -9.135985238051259e-07 -0.07671676362405928 +0.6671 0.6646871776029291 0.6646849050769482 -9.244570299271615e-07 -0.07672301342157442 +0.6672 0.6646989190401212 0.6646966645304786 -9.351338735030801e-07 -0.07672926176240837 +0.6673000000000001 0.6647106574243191 0.6647084211437579 -9.456268944274537e-07 -0.07673550864678205 +0.6674000000000001 0.6647223927579662 0.6647201749154866 -9.559339702036596e-07 -0.07674175407491649 +0.6675 0.6647341250435261 0.6647319258443436 -9.660530164989911e-07 -0.07674799804703258 +0.6676 0.6647458542834842 0.6647436739289869 -9.75981987366703e-07 -0.07675424056335135 +0.6677000000000001 0.664757580480346 0.6647554191680549 -9.85718875773367e-07 -0.07676048162409391 +0.6678000000000001 0.664769303636637 0.6647671615601651 -9.952617139874498e-07 -0.07676672122948128 +0.6679 0.6647810237549024 0.6647789011039158 -1.0046085740511579e-06 -0.07677295937973462 +0.668 0.6647927408377066 0.6647906377978856 -1.0137575680579936e-06 -0.07677919607507505 +0.6681 0.6648044548876324 0.6648023716406348 -1.0227068486801105e-06 -0.07678543131572374 +0.6682 0.6648161659072818 0.6648141026307046 -1.0314546094181143e-06 -0.0767916651019019 +0.6683000000000001 0.6648278738992741 0.6648258307666192 -1.039999084934129e-06 -0.07679789743383081 +0.6684000000000001 0.6648395788662463 0.6648375560468838 -1.0483385516346644e-06 -0.07680412831173161 +0.6685 0.6648512808108529 0.6648492784699875 -1.0564713276706161e-06 -0.07681035773582576 +0.6686 0.6648629797357645 0.6648609980344026 -1.0643957737699328e-06 -0.07681658570633451 +0.6687000000000001 0.6648746756436684 0.6648727147385846 -1.0721102929878157e-06 -0.0768228122234792 +0.6688000000000001 0.6648863685372677 0.6648844285809733 -1.0796133314561196e-06 -0.07682903728748126 +0.6689 0.664898058419281 0.664896139559993 -1.0869033785776416e-06 -0.07683526089856213 +0.669 0.6649097452924415 0.6649078476740534 -1.0939789673314326e-06 -0.07684148305694323 +0.6691 0.6649214291594969 0.6649195529215488 -1.1008386744948417e-06 -0.07684770376284596 +0.6692 0.6649331100232099 0.6649312553008601 -1.1074811211708724e-06 -0.07685392301649197 +0.6693000000000001 0.6649447878863557 0.6649429548103541 -1.113904972732671e-06 -0.07686014081810273 +0.6694000000000001 0.6649564627517234 0.6649546514483847 -1.1201089392953723e-06 -0.07686635716789984 +0.6695 0.6649681346221147 0.6649663452132928 -1.126091776049165e-06 -0.07687257206610491 +0.6696 0.6649798035003432 0.664978036103407 -1.131852283370316e-06 -0.07687878551293956 +0.6697000000000001 0.6649914693892348 0.6649897241170438 -1.1373893069877017e-06 -0.0768849975086254 +0.6698000000000001 0.6650031322916268 0.6650014092525091 -1.1427017384546545e-06 -0.07689120805338426 +0.6699 0.665014792210367 0.665013091508097 -1.1477885152322287e-06 -0.0768974171474378 +0.67 0.6650264491483135 0.6650247708820913 -1.1526486209112452e-06 -0.07690362479100771 +0.6701 0.6650381031083351 0.6650364473727661 -1.1572810854065807e-06 -0.07690983098431586 +0.6702 0.6650497540933095 0.665048120978386 -1.1616849852624789e-06 -0.07691603572758404 +0.6703000000000001 0.6650614021061236 0.665059791697206 -1.1658594437080616e-06 -0.07692223902103414 +0.6704000000000001 0.665073047149673 0.6650714595274729 -1.1698036309071291e-06 -0.07692844086488797 +0.6705 0.6650846892268611 0.6650831244674252 -1.1735167641246935e-06 -0.07693464125936748 +0.6706 0.665096328340599 0.6650947865152941 -1.1769981077269787e-06 -0.07694084020469458 +0.6707000000000001 0.6651079644938049 0.6651064456693033 -1.180246973653265e-06 -0.07694703770109129 +0.6708000000000001 0.6651195976894037 0.66511810192767 -1.183262721332623e-06 -0.07695323374877952 +0.6709 0.6651312279303263 0.6651297552886049 -1.1860447577671795e-06 -0.07695942834798136 +0.671 0.6651428552195098 0.6651414057503133 -1.188592537809674e-06 -0.0769656214989189 +0.6711 0.6651544795598958 0.6651530533109953 -1.1909055641912136e-06 -0.07697181320181416 +0.6712 0.665166100954431 0.6651646979688457 -1.192983387632296e-06 -0.07697800345688927 +0.6713000000000001 0.6651777194060662 0.6651763397220561 -1.1948256068150531e-06 -0.07698419226436644 +0.6714000000000001 0.6651893349177559 0.6651879785688132 -1.1964318688828524e-06 -0.07699037962446775 +0.6715 0.6652009474924581 0.6651996145073009 -1.1978018688851844e-06 -0.0769965655374155 +0.6716 0.6652125571331331 0.6652112475357006 -1.1989353503605304e-06 -0.0770027500034319 +0.6717000000000001 0.6652241638427441 0.6652228776521907 -1.1998321050865624e-06 -0.07700893302273917 +0.6718000000000001 0.6652357676242554 0.6652345048549482 -1.2004919733299424e-06 -0.07701511459555965 +0.6719 0.6652473684806334 0.6652461291421485 -1.2009148435687678e-06 -0.07702129472211568 +0.672 0.665258966414844 0.6652577505119666 -1.2011006530199264e-06 -0.07702747340262951 +0.6721 0.6652705614298549 0.6652693689625765 -1.2010493870839856e-06 -0.07703365063732359 +0.6722 0.6652821535286327 0.6652809844921532 -1.2007610798170365e-06 -0.07703982642642039 +0.6723000000000001 0.6652937427141437 0.6652925970988713 -1.200235813569872e-06 -0.07704600077014226 +0.6724000000000001 0.6653053289893528 0.6653042067809076 -1.1994737191545202e-06 -0.07705217366871174 +0.6725 0.6653169123572236 0.6653158135364395 -1.1984749757887325e-06 -0.07705834512235131 +0.6726 0.6653284928207172 0.665327417363647 -1.1972398110682292e-06 -0.07706451513128348 +0.6727000000000001 0.6653400703827923 0.6653390182607127 -1.1957685007724095e-06 -0.07707068369573083 +0.6728000000000001 0.6653516450464043 0.6653506162258221 -1.194061369197419e-06 -0.07707685081591593 +0.6729 0.6653632168145052 0.6653622112571644 -1.1921187886010376e-06 -0.07708301649206144 +0.673 0.6653747856900427 0.6653738033529326 -1.1899411793969694e-06 -0.07708918072438993 +0.6731 0.6653863516759604 0.6653853925113244 -1.1875290100715752e-06 -0.07709534351312416 +0.6732 0.6653979147751963 0.6653969787305427 -1.184882796906317e-06 -0.07710150485848678 +0.6733000000000001 0.665409474990683 0.6654085620087954 -1.1820031041998025e-06 -0.07710766476070056 +0.6734000000000001 0.6654210323253473 0.6654201423442969 -1.1788905436849184e-06 -0.07711382321998828 +0.6735 0.665432586782109 0.6654317197352679 -1.1755457748896525e-06 -0.07711998023657265 +0.6736 0.6654441383638817 0.6654432941799356 -1.1719695047762713e-06 -0.07712613581067657 +0.6737000000000001 0.6654556870735706 0.6654548656765353 -1.1681624873804974e-06 -0.07713228994252284 +0.6738000000000001 0.6654672329140741 0.6654664342233096 -1.1641255241168214e-06 -0.07713844263233438 +0.6739 0.6654787758882805 0.6654779998185099 -1.1598594631678782e-06 -0.07714459388033401 +0.674 0.665490315999071 0.6654895624603963 -1.1553651996509817e-06 -0.07715074368674477 +0.6741 0.6655018532493164 0.6655011221472382 -1.1506436753683236e-06 -0.07715689205178955 +0.6742 0.6655133876418778 0.6655126788773148 -1.1456958782241067e-06 -0.07716303897569135 +0.6743000000000001 0.6655249191796063 0.6655242326489155 -1.1405228426408787e-06 -0.07716918445867321 +0.6744000000000001 0.665536447865342 0.6655357834603406 -1.1351256488101313e-06 -0.07717532850095819 +0.6745 0.6655479737019139 0.6655473313099014 -1.1295054229698565e-06 -0.07718147110276935 +0.6746 0.6655594966921388 0.6655588761959208 -1.1236633366273896e-06 -0.07718761226432976 +0.6747000000000001 0.665571016838822 0.6655704181167339 -1.1176006067814548e-06 -0.07719375198586259 +0.6748000000000001 0.6655825341447562 0.6655819570706887 -1.1113184953115418e-06 -0.07719989026759103 +0.6749 0.6655940486127203 0.6655934930561459 -1.1048183090334174e-06 -0.07720602710973823 +0.675 0.6656055602454807 0.6656050260714794 -1.0981013993383026e-06 -0.07721216251252744 +0.6751 0.6656170690457887 0.6656165561150778 -1.0911691616655173e-06 -0.07721829647618189 +0.6752 0.6656285750163821 0.665628083185343 -1.084023035585746e-06 -0.07722442900092488 +0.6753000000000001 0.6656400781599832 0.6656396072806924 -1.0766645041349054e-06 -0.07723056008697965 +0.6754000000000001 0.6656515784792998 0.6656511283995585 -1.0690950938696542e-06 -0.0772366897345696 +0.6755 0.6656630759770228 0.6656626465403896 -1.0613163745065712e-06 -0.07724281794391799 +0.6756 0.665674570655828 0.6656741617016504 -1.053329958172755e-06 -0.07724894471524832 +0.6757000000000001 0.6656860625183743 0.6656856738818211 -1.0451374996001128e-06 -0.07725507004878394 +0.6758000000000001 0.6656975515673031 0.6656971830794003 -1.036740695542493e-06 -0.07726119394474834 +0.6759000000000001 0.6657090378052393 0.6657086892929026 -1.0281412844426185e-06 -0.07726731640336496 +0.676 0.6657205212347888 0.6657201925208611 -1.0193410459602426e-06 -0.07727343742485726 +0.6761 0.6657320018585398 0.6657316927618276 -1.0103418009166365e-06 -0.07727955700944879 +0.6762 0.665743479679062 0.6657431900143718 -1.001145410739479e-06 -0.07728567515736313 +0.6763000000000001 0.6657549546989057 0.6657546842770827 -9.917537769077445e-07 -0.07729179186882387 +0.6764000000000001 0.6657664269206014 0.6657661755485688 -9.82168840923947e-07 -0.07729790714405455 +0.6765 0.6657778963466607 0.6657776638274584 -9.72392583536985e-07 -0.07730402098327888 +0.6766 0.6657893629795736 0.6657891491124002 -9.624270247143851e-07 -0.07731013338672046 +0.6767000000000001 0.6658008268218104 0.6658006314020635 -9.522742229206571e-07 -0.07731624435460306 +0.6768000000000001 0.6658122878758197 0.6658121106951385 -9.419362747287163e-07 -0.07732235388715034 +0.6769000000000001 0.6658237461440288 0.6658235869903371 -9.314153147088611e-07 -0.07732846198458605 +0.677 0.6658352016288434 0.6658350602863925 -9.207135145128387e-07 -0.07733456864713396 +0.6771 0.6658466543326467 0.6658465305820609 -9.09833082901601e-07 -0.07734067387501793 +0.6772 0.6658581042577993 0.6658579978761203 -8.98776264746104e-07 -0.07734677766846175 +0.6773 0.6658695514066386 0.6658694621673715 -8.875453411799628e-07 -0.07735288002768917 +0.6774000000000001 0.6658809957814793 0.6658809234546397 -8.761426287112739e-07 -0.07735898095292422 +0.6775 0.665892437384612 0.6658923817367726 -8.645704788201591e-07 -0.07736508044439078 +0.6776 0.6659038762183034 0.6659038370126421 -8.528312775563096e-07 -0.07737117850231272 +0.6777000000000001 0.6659153122847956 0.6659152892811451 -8.409274450255078e-07 -0.07737727512691406 +0.6778000000000001 0.6659267455863062 0.6659267385412022 -8.28861434890027e-07 -0.07738337031841877 +0.6779000000000001 0.6659381761250277 0.6659381847917598 -8.166357337857644e-07 -0.07738946407705088 +0.678 0.665949603903127 0.6659496280317891 -8.04252860933663e-07 -0.07739555640303442 +0.6781 0.6659610289227453 0.6659610682602877 -7.917153675984778e-07 -0.07740164729659345 +0.6782 0.6659724511859983 0.6659725054762782 -7.790258363810088e-07 -0.07740773675795211 +0.6783 0.6659838706949748 0.6659839396788103 -7.661868811070782e-07 -0.0774138247873345 +0.6784000000000001 0.6659952874517371 0.6659953708669599 -7.53201145800575e-07 -0.07741991138496478 +0.6785 0.6660067014583203 0.6660067990398302 -7.400713045307983e-07 -0.07742599655106713 +0.6786 0.6660181127167325 0.6660182241965512 -7.268000605381575e-07 -0.07743208028586575 +0.6787000000000001 0.6660295212289542 0.6660296463362806 -7.133901459427383e-07 -0.07743816258958489 +0.6788000000000001 0.6660409269969376 0.6660410654582037 -6.998443211059246e-07 -0.07744424346244874 +0.6789000000000001 0.6660523300226078 0.6660524815615344 -6.86165373950387e-07 -0.07745032290468164 +0.679 0.6660637303078603 0.6660638946455145 -6.723561195576266e-07 -0.0774564009165079 +0.6791 0.6660751278545625 0.6660753047094146 -6.584193995018417e-07 -0.07746247749815184 +0.6792 0.666086522664553 0.6660867117525342 -6.443580812254268e-07 -0.07746855264983785 +0.6793 0.6660979147396409 0.6660981157742017 -6.301750575116172e-07 -0.07747462637179026 +0.6794000000000001 0.666109304081606 0.6661095167737756 -6.158732458738658e-07 -0.07748069866423357 +0.6795 0.6661206906921981 0.6661209147506432 -6.014555880423655e-07 -0.07748676952739218 +0.6796 0.6661320745731377 0.6661323097042224 -5.869250491452593e-07 -0.07749283896149059 +0.6797000000000001 0.6661434557261139 0.6661437016339606 -5.722846174172069e-07 -0.07749890696675318 +0.6798000000000001 0.6661548341527868 0.6661550905393363 -5.575373032279396e-07 -0.07750497354340463 +0.6799000000000001 0.666166209854785 0.6661664764198579 -5.426861387491932e-07 -0.07751103869166942 +0.68 0.6661775828337062 0.666177859275065 -5.277341771220412e-07 -0.07751710241177208 +0.6801 0.6661889530911176 0.6661892391045281 -5.126844920544382e-07 -0.07752316470393728 +0.6802 0.6662003206285548 0.6662006159078488 -4.97540177016309e-07 -0.07752922556838962 +0.6803 0.6662116854475219 0.6662119896846603 -4.823043446428033e-07 -0.07753528500535371 +0.6804000000000001 0.6662230475494914 0.6662233604346277 -4.669801261375506e-07 -0.07754134301505433 +0.6805 0.6662344069359039 0.666234728157447 -4.5157067053713806e-07 -0.07754739959771612 +0.6806 0.666245763608168 0.6662460928528469 -4.3607914421150973e-07 -0.0775534547535638 +0.6807000000000001 0.66625711756766 0.6662574545205877 -4.2050873010068823e-07 -0.07755950848282211 +0.6808000000000001 0.6662684688157244 0.6662688131604627 -4.0486262706251885e-07 -0.07756556078571589 +0.6809000000000001 0.6662798173536726 0.6662801687722972 -3.891440492828635e-07 -0.0775716116624699 +0.681 0.6662911631827835 0.6662915213559493 -3.7335622557477244e-07 -0.07757766111330901 +0.6811 0.666302506304303 0.6663028709113091 -3.5750239873316714e-07 -0.07758370913845802 +0.6812 0.6663138467194446 0.666314217438301 -3.415858248270731e-07 -0.0775897557381419 +0.6813 0.6663251844293882 0.6663255609368814 -3.2560977259593615e-07 -0.07759580091258551 +0.6814000000000001 0.6663365194352805 0.6663369014070399 -3.0957752272103845e-07 -0.07760184466201375 +0.6815 0.6663478517382351 0.6663482388487998 -2.9349236717324256e-07 -0.07760788698665162 +0.6816 0.6663591813393326 0.6663595732622174 -2.7735760855379654e-07 -0.07761392788672415 +0.6817000000000001 0.6663705082396191 0.6663709046473827 -2.6117655942126117e-07 -0.07761996736245627 +0.6818000000000001 0.6663818324401076 0.666382233004419 -2.4495254153517054e-07 -0.07762600541407305 +0.6819000000000001 0.6663931539417776 0.6663935583334837 -2.2868888529745113e-07 -0.07763204204179955 +0.682 0.6664044727455743 0.6664048806347675 -2.123889289579184e-07 -0.07763807724586089 +0.6821 0.6664157888524096 0.6664161999084951 -1.9605601800365413e-07 -0.07764411102648214 +0.6822 0.6664271022631609 0.6664275161549251 -1.7969350443042265e-07 -0.07765014338388844 +0.6823 0.6664384129786717 0.6664388293743503 -1.6330474608000634e-07 -0.07765617431830497 +0.6824000000000001 0.6664497209997513 0.666450139567097 -1.468931059220302e-07 -0.07766220382995691 +0.6825 0.6664610263271756 0.666461446733526 -1.3046195140690997e-07 -0.07766823191906946 +0.6826 0.6664723289616858 0.666472750874032 -1.1401465372859465e-07 -0.0776742585858679 +0.6827000000000001 0.6664836289039886 0.6664840519890438 -9.755458716537158e-08 -0.07768028383057746 +0.6828000000000001 0.6664949261547573 0.6664953500790245 -8.108512836949716e-08 -0.07768630765342338 +0.6829000000000001 0.6665062207146302 0.6665066451444712 -6.46096556871853e-08 -0.07769233005463107 +0.683 0.6665175125842118 0.6665179371859158 -4.8131548455176976e-08 -0.07769835103442584 +0.6831 0.666528801764072 0.6665292262039233 -3.165418631313928e-08 -0.07770437059303303 +0.6832 0.666540088254747 0.6665405121990938 -1.518094850782442e-08 -0.07771038873067804 +0.6833 0.6665513720567382 0.6665517951720612 1.2847868029880471e-09 -0.07771640544758628 +0.6834000000000001 0.6665626531705129 0.6665630751234939 1.7739643235273328e-08 -0.0777224207439832 +0.6835 0.6665739315965042 0.6665743520540942 3.4180246881107545e-08 -0.07772843462009424 +0.6836 0.6665852073351112 0.666585625964598 5.060322699063091e-08 -0.07773444707614485 +0.6837000000000001 0.6665964803866987 0.6665968968557765 6.700521667721282e-08 -0.0777404581123606 +0.6838000000000001 0.6666077507515973 0.666608164728434 8.338285360440234e-08 -0.07774646772896704 +0.6839000000000001 0.6666190184301037 0.6666194295834093 9.973278065206204e-08 -0.07775247592618968 +0.684 0.6666302834224808 0.6666306914215744 1.160516466432171e-07 -0.07775848270425408 +0.6841 0.6666415457289568 0.6666419502438364 1.323361070205975e-07 -0.07776448806338594 +0.6842 0.6666528053497273 0.6666532060511354 1.4858282450583293e-07 -0.07777049200381088 +0.6843 0.6666640622849527 0.666664458844445 1.647884698176283e-07 -0.07777649452575447 +0.6844000000000001 0.6666753165347605 0.666675708624773 1.8094972233789752e-07 -0.07778249562944245 +0.6845 0.6666865680992446 0.6666869553931604 1.970632707987141e-07 -0.07778849531510054 +0.6846 0.6666978169784651 0.666698199150682 2.1312581396232266e-07 -0.07779449358295443 +0.6847000000000001 0.6667090631724489 0.6667094398984457 2.2913406130115055e-07 -0.0778004904332299 +0.6848000000000001 0.6667203066811898 0.6667206776375925 2.4508473366047223e-07 -0.07780648586615269 +0.6849000000000001 0.6667315475046477 0.6667319123692969 2.60974563931482e-07 -0.07781247988194867 +0.685 0.6667427856427502 0.6667431440947661 2.7680029773824444e-07 -0.07781847248084363 +0.6851 0.6667540210953917 0.6667543728152402 2.925586940830116e-07 -0.07782446366306342 +0.6852 0.6667652538624339 0.6667655985319922 3.082465260401124e-07 -0.07783045342883393 +0.6853 0.6667764839437055 0.6667768212463273 3.238605814359641e-07 -0.07783644177838102 +0.6854000000000001 0.666787711339003 0.6667880409595836 3.393976633903062e-07 -0.07784242871193064 +0.6855 0.666798936048091 0.666799257673131 3.5485459113498985e-07 -0.07784841422970873 +0.6856 0.6668101580707014 0.6668104713883716 3.7022820053439487e-07 -0.07785439833194124 +0.6857000000000001 0.6668213774065342 0.6668216821067399 3.855153448278914e-07 -0.07786038101885423 +0.6858000000000001 0.6668325940552575 0.6668328898297016 4.0071289520576814e-07 -0.07786636229067367 +0.6859000000000001 0.6668438080165082 0.6668440945587538 4.1581774151699946e-07 -0.07787234214762556 +0.686 0.6668550192898913 0.6668552962954257 4.30826792824357e-07 -0.07787832058993603 +0.6861 0.6668662278749812 0.6668664950412773 4.457369781052378e-07 -0.07788429761783118 +0.6862 0.6668774337713206 0.666877690797899 4.6054524689698173e-07 -0.07789027323153706 +0.6863 0.6668886369784217 0.6668888835669131 4.7524856980341035e-07 -0.07789624743127989 +0.6864000000000001 0.6668998374957659 0.6669000733499713 4.898439393136167e-07 -0.07790222021728574 +0.6865 0.6669110353228046 0.6669112601487561 5.043283701905432e-07 -0.07790819158978082 +0.6866 0.666922230458959 0.6669224439649801 5.186989003036491e-07 -0.07791416154899135 +0.6867000000000001 0.6669334229036202 0.6669336248003859 5.329525910174882e-07 -0.07792013009514358 +0.6868000000000001 0.6669446126561495 0.6669448026567454 5.470865280660098e-07 -0.07792609722846369 +0.6869000000000001 0.6669557997158793 0.6669559775358599 5.610978218439922e-07 -0.07793206294917801 +0.687 0.6669669840821124 0.6669671494395598 5.749836081980764e-07 -0.07793802725751287 +0.6871 0.666978165754123 0.6669783183697043 5.887410489680001e-07 -0.07794399015369452 +0.6872 0.6669893447311566 0.6669894843281814 6.023673325555867e-07 -0.07794995163794932 +0.6873 0.6670005210124302 0.6670006473169068 6.158596745492462e-07 -0.07795591171050366 +0.6874000000000001 0.667011694597133 0.6670118073378252 6.292153182235749e-07 -0.07796187037158397 +0.6875 0.6670228654844264 0.667022964392908 6.424315351222232e-07 -0.07796782762141663 +0.6876 0.6670340336734435 0.6670341184841547 6.555056257379066e-07 -0.07797378346022807 +0.6877000000000001 0.6670451991632914 0.6670452696135917 6.684349197899619e-07 -0.07797973788824475 +0.6878000000000001 0.6670563619530496 0.6670564177832723 6.812167770570143e-07 -0.07798569090569317 +0.6879000000000001 0.6670675220417708 0.6670675629952763 6.938485877933109e-07 -0.07799164251279977 +0.688 0.667078679428482 0.6670787052517095 7.063277732838324e-07 -0.07799759270979119 +0.6881 0.6670898341121841 0.6670898445547043 7.186517862606268e-07 -0.07800354149689391 +0.6882 0.667100986091852 0.6671009809064178 7.308181117215984e-07 -0.07800948887433448 +0.6883 0.6671121353664355 0.667112114309033 7.428242670554086e-07 -0.07801543484233958 +0.6884000000000001 0.6671232819348598 0.6671232447647577 7.546678028880205e-07 -0.07802137940113581 +0.6885 0.6671344257960249 0.6671343722758236 7.663463034573992e-07 -0.07802732255094974 +0.6886 0.6671455669488067 0.6671454968444879 7.778573868494343e-07 -0.0780332642920081 +0.6887000000000001 0.6671567053920573 0.6671566184730305 7.891987060804073e-07 -0.07803920462453762 +0.6888000000000001 0.6671678411246047 0.6671677371637557 8.003679489720916e-07 -0.07804514354876488 +0.6889000000000001 0.667178974145254 0.6671788529189902 8.113628391093197e-07 -0.0780510810649167 +0.689 0.6671901044527877 0.6671899657410845 8.221811358261055e-07 -0.07805701717321985 +0.6891 0.6672012320459655 0.6672010756324105 8.328206351215783e-07 -0.0780629518739011 +0.6892 0.6672123569235249 0.667212182595363 8.432791697710051e-07 -0.07806888516718723 +0.6893 0.6672234790841816 0.6672232866323577 8.535546101029468e-07 -0.07807481705330505 +0.6894000000000001 0.6672345985266301 0.6672343877458324 8.6364486398538e-07 -0.0780807475324814 +0.6895 0.6672457152495441 0.6672454859382457 8.735478776444872e-07 -0.07808667660494323 +0.6896 0.6672568292515759 0.6672565812120761 8.832616360254786e-07 -0.0780926042709173 +0.6897000000000001 0.6672679405313586 0.6672676735698229 8.927841629868816e-07 -0.07809853053063065 +0.6898000000000001 0.6672790490875047 0.6672787630140051 9.021135219944298e-07 -0.07810445538431013 +0.6899000000000001 0.6672901549186077 0.6672898495471604 9.112478162320858e-07 -0.07811037883218269 +0.69 0.667301258023242 0.6673009331718462 9.201851892126633e-07 -0.07811630087447538 +0.6901 0.6673123583999636 0.6673120138906383 9.289238250276277e-07 -0.07812222151141512 +0.6902 0.66732345604731 0.6673230917061306 9.374619488466962e-07 -0.07812814074322905 +0.6903 0.6673345509638009 0.667334166620934 9.457978271953937e-07 -0.07813405857014408 +0.6904000000000001 0.667345643147939 0.6673452386376777 9.539297682326087e-07 -0.07813997499238734 +0.6905 0.6673567325982099 0.6673563077590069 9.61856122194682e-07 -0.07814589001018589 +0.6906 0.6673678193130828 0.6673673739875838 9.695752817839853e-07 -0.07815180362376689 +0.6907000000000001 0.6673789032910104 0.6673784373260867 9.770856824464769e-07 -0.07815771583335743 +0.6908000000000001 0.6673899845304305 0.6673894977772086 9.843858026215013e-07 -0.07816362663918464 +0.6909000000000001 0.6674010630297652 0.6674005553436584 9.914741641303682e-07 -0.07816953604147574 +0.691 0.6674121387874223 0.6674116100281596 9.983493324816628e-07 -0.07817544404045794 +0.6911 0.6674232118017949 0.6674226618334496 1.0050099170932913e-06 -0.07818135063635841 +0.6912 0.6674342820712624 0.6674337107622799 1.0114545715700363e-06 -0.07818725582940445 +0.6913 0.6674453495941907 0.6674447568174147 1.0176819941754012e-06 -0.0781931596198232 +0.6914000000000001 0.667456414368933 0.6674558000016322 1.023690927887122e-06 -0.07819906200784212 +0.6915 0.6674674763938299 0.6674668403177221 1.0294801607579895e-06 -0.0782049629936884 +0.6916 0.6674785356672097 0.6674778777684864 1.0350485260268716e-06 -0.07821086257758937 +0.6917000000000001 0.6674895921873893 0.6674889123567385 1.0403949025905579e-06 -0.07821676075977238 +0.6918000000000001 0.6675006459526751 0.6674999440853027 1.04551821500376e-06 -0.07822265754046484 +0.6919000000000001 0.6675116969613617 0.6675109729570143 1.050417433784423e-06 -0.07822855291989406 +0.692 0.6675227452117345 0.6675219989747184 1.0550915756635248e-06 -0.07823444689828751 +0.6921 0.6675337907020689 0.6675330221412699 1.059539703862633e-06 -0.07824033947587265 +0.6922 0.6675448334306308 0.6675440424595325 1.0637609280939042e-06 -0.07824623065287688 +0.6923 0.6675558733956776 0.6675550599323791 1.0677544046155951e-06 -0.07825212042952763 +0.6924000000000001 0.6675669105954583 0.6675660745626903 1.0715193369814635e-06 -0.07825800880605248 +0.6925 0.6675779450282145 0.6675770863533551 1.075054975707701e-06 -0.07826389578267894 +0.6926 0.6675889766921799 0.6675880953072693 1.0783606183284444e-06 -0.0782697813596345 +0.6927000000000001 0.6676000055855817 0.6675991014273355 1.081435610089665e-06 -0.07827566553714678 +0.6928000000000001 0.6676110317066406 0.6676101047164624 1.0842793434218123e-06 -0.07828154831544332 +0.6929000000000001 0.6676220550535712 0.6676211051775649 1.0868912588002377e-06 -0.07828742969475168 +0.693 0.6676330756245835 0.6676321028135633 1.08927084407906e-06 -0.07829330967529957 +0.6931 0.6676440934178818 0.6676430976273824 1.0914176350740323e-06 -0.07829918825731458 +0.6932 0.6676551084316658 0.6676540896219516 1.0933312157290764e-06 -0.07830506544102436 +0.6933 0.6676661206641321 0.6676650788002041 1.0950112177554594e-06 -0.07831094122665666 +0.6934000000000001 0.6676771301134734 0.6676760651650764 1.0964573212146611e-06 -0.07831681561443912 +0.6935 0.6676881367778795 0.667687048719508 1.0976692541853073e-06 -0.07832268860459955 +0.6936 0.6676991406555375 0.6676980294664405 1.0986467929019472e-06 -0.07832856019736556 +0.6937000000000001 0.667710141744633 0.6677090074088181 1.0993897621158766e-06 -0.07833443039296505 +0.6938000000000001 0.6677211400433491 0.6677199825495855 1.0998980346232923e-06 -0.07834029919162566 +0.6939000000000001 0.6677321355498693 0.6677309548916894 1.1001715316538707e-06 -0.07834616659357535 +0.694 0.6677431282623756 0.6677419244380763 1.1002102228707678e-06 -0.07835203259904185 +0.6941 0.6677541181790503 0.6677528911916926 1.100014126148574e-06 -0.07835789720825304 +0.6942 0.6677651052980762 0.6677638551554843 1.0995833077120931e-06 -0.0783637604214368 +0.6943 0.6677760896176368 0.6677748163323967 1.0989178821085854e-06 -0.078369622238821 +0.6944000000000001 0.6677870711359173 0.6677857747253728 1.0980180123465466e-06 -0.0783754826606336 +0.6945 0.6677980498511047 0.6677967303373544 1.0968839093683513e-06 -0.07838134168710244 +0.6946 0.6678090257613886 0.6678076831712804 1.0955158326331205e-06 -0.0783871993184555 +0.6947000000000001 0.6678199988649614 0.6678186332300868 1.0939140896171207e-06 -0.0783930555549208 +0.6948000000000001 0.6678309691600188 0.6678295805167062 1.0920790359802979e-06 -0.0783989103967263 +0.6949000000000001 0.6678419366447608 0.6678405250340669 1.090011075260966e-06 -0.07840476384409999 +0.695 0.667852901317391 0.6678514667850932 1.0877106590423402e-06 -0.07841061589726989 +0.6951 0.6678638631761185 0.6678624057727044 1.085178286702737e-06 -0.07841646655646406 +0.6952 0.6678748222191577 0.6678733419998142 1.0824145052490408e-06 -0.07842231582191062 +0.6953 0.667885778444729 0.6678842754693304 1.0794199095942592e-06 -0.07842816369383765 +0.6954000000000001 0.6678967318510581 0.6678952061841547 1.0761951418913895e-06 -0.0784340101724732 +0.6955 0.6679076824363789 0.6679061341471815 1.0727408916999526e-06 -0.07843985525804548 +0.6956 0.6679186301989317 0.667917059361298 1.0690578958749697e-06 -0.0784456989507826 +0.6957000000000001 0.6679295751369649 0.6679279818293837 1.0651469382616519e-06 -0.0784515412509127 +0.6958000000000001 0.6679405172487347 0.6679389015543102 1.061008849667644e-06 -0.07845738215866406 +0.6959000000000001 0.6679514565325064 0.6679498185389392 1.0566445074189357e-06 -0.07846322167426477 +0.696 0.6679623929865546 0.6679607327861239 1.0520548357206838e-06 -0.07846905979794311 +0.6961 0.667973326609163 0.6679716442987079 1.0472408047967896e-06 -0.07847489652992734 +0.6962 0.667984257398626 0.6679825530795244 1.0422034312507211e-06 -0.07848073187044571 +0.6963 0.6679951853532484 0.6679934591313963 1.0369437774826462e-06 -0.0784865658197266 +0.6964000000000001 0.6680061104713457 0.6680043624571346 1.0314629517449436e-06 -0.07849239837799821 +0.6965 0.6680170327512454 0.6680152630595388 1.025762107559336e-06 -0.07849822954548885 +0.6966 0.6680279521912869 0.6680261609413976 1.019842443883423e-06 -0.07850405932242699 +0.6967000000000001 0.668038868789822 0.6680370561054856 1.013705204527815e-06 -0.07850988770904092 +0.6968000000000001 0.6680497825452149 0.6680479485545654 1.007351678156132e-06 -0.07851571470555901 +0.6969000000000001 0.6680606934558437 0.6680588382913857 1.0007831978131598e-06 -0.0785215403122097 +0.697 0.6680716015201004 0.668069725318682 9.94001140758316e-07 -0.07852736452922138 +0.6971 0.6680825067363907 0.6680806096391747 9.8700692821585e-07 -0.07853318735682255 +0.6972 0.6680934091031352 0.6680914912555695 9.79802024986265e-07 -0.07853900879524156 +0.6973 0.66810430861877 0.668102370170558 9.72387939085495e-07 -0.07854482884470702 +0.6974000000000001 0.6681152052817463 0.6681132463868147 9.647662216061281e-07 -0.07855064750544734 +0.6975 0.6681260990905313 0.6681241199069989 9.569384663010716e-07 -0.07855646477769111 +0.6976 0.6681369900436092 0.6681349907337532 9.489063092504857e-07 -0.07856228066166682 +0.6977000000000001 0.6681478781394801 0.6681458588697031 9.40671428500961e-07 -0.07856809515760303 +0.6978000000000001 0.6681587633766621 0.6681567243174575 9.322355438434737e-07 -0.07857390826572835 +0.6979000000000001 0.6681696457536911 0.6681675870796066 9.236004163137856e-07 -0.07857971998627138 +0.698 0.6681805252691204 0.6681784471587224 9.147678478316212e-07 -0.07858553031946065 +0.6981 0.6681914019215227 0.6681893045573594 9.057396809786233e-07 -0.07859133926552496 +0.6982 0.6682022757094888 0.6682001592780518 8.965177983877304e-07 -0.0785971468246928 +0.6983 0.6682131466316292 0.6682110113233151 8.871041225488874e-07 -0.07860295299719289 +0.6984000000000001 0.6682240146865744 0.6682218606956447 8.775006153927123e-07 -0.07860875778325395 +0.6985 0.6682348798729749 0.6682327073975162 8.677092776521178e-07 -0.07861456118310468 +0.6986 0.6682457421895016 0.6682435514313843 8.577321488068002e-07 -0.07862036319697385 +0.6987000000000001 0.6682566016348463 0.6682543927996825 8.475713063615942e-07 -0.07862616382509013 +0.6988000000000001 0.6682674582077224 0.668265231504823 8.372288655966731e-07 -0.0786319630676823 +0.6989000000000001 0.6682783119068645 0.6682760675491963 8.267069790401926e-07 -0.07863776092497918 +0.699 0.6682891627310297 0.6682869009351711 8.160078361074685e-07 -0.07864355739720953 +0.6991 0.6683000106789975 0.6682977316650931 8.051336625319871e-07 -0.07864935248460221 +0.6992 0.66831085574957 0.6683085597412852 7.94086719949072e-07 -0.07865514618738602 +0.6993 0.6683216979415729 0.6683193851660474 7.828693054517943e-07 -0.07866093850578987 +0.6994000000000001 0.6683325372538549 0.6683302079416558 7.714837511330064e-07 -0.0786667294400426 +0.6995 0.6683433736852887 0.6683410280703628 7.599324235441074e-07 -0.07867251899037314 +0.6996 0.6683542072347715 0.6683518455543958 7.482177232093212e-07 -0.07867830715701037 +0.6997000000000001 0.6683650379012249 0.6683626603959585 7.363420842371182e-07 -0.07868409394018323 +0.6998000000000001 0.6683758656835951 0.668373472597229 7.243079736402036e-07 -0.07868987934012066 +0.6999000000000001 0.6683866905808539 0.6683842821603605 7.121178909885728e-07 -0.07869566335705161 +0.7 0.6683975125919986 0.6683950890874798 6.997743677711332e-07 -0.07870144599120507 +0.7001000000000001 0.6684083317160527 0.6684058933806889 6.872799669793705e-07 -0.0787072272428101 +0.7002 0.6684191479520654 0.6684166950420627 6.746372824689706e-07 -0.07871300711209568 +0.7003 0.6684299612991126 0.6684274940736498 6.618489384740966e-07 -0.07871878559929087 +0.7004000000000001 0.6684407717562968 0.6684382904774716 6.489175890106447e-07 -0.07872456270462472 +0.7005 0.6684515793227481 0.6684490842555227 6.358459175154207e-07 -0.07873033842832627 +0.7006 0.6684623839976237 0.66845987540977 6.226366360412294e-07 -0.07873611277062469 +0.7007000000000001 0.6684731857801085 0.6684706639421527 6.092924848682957e-07 -0.07874188573174902 +0.7008000000000001 0.6684839846694154 0.6684814498545821 5.958162318658866e-07 -0.07874765731192844 +0.7009000000000001 0.6684947806647857 0.6684922331489407 5.822106719094444e-07 -0.07875342751139208 +0.701 0.668505573765489 0.6685030138270829 5.68478626380986e-07 -0.07875919633036908 +0.7011000000000001 0.668516363970824 0.6685137918908337 5.546229424752136e-07 -0.07876496376908868 +0.7012 0.668527151280118 0.6685245673419895 5.406464926860366e-07 -0.07877072982778001 +0.7013 0.6685379356927282 0.6685353401823173 5.265521741681933e-07 -0.07877649450667236 +0.7014000000000001 0.6685487172080407 0.6685461104135538 5.123429081960174e-07 -0.07878225780599492 +0.7015 0.6685594958254721 0.6685568780374068 4.98021639538937e-07 -0.07878801972597699 +0.7016 0.6685702715444684 0.668567643055553 4.83591335753708e-07 -0.07879378026684779 +0.7017 0.6685810443645063 0.6685784054696395 4.6905498678195823e-07 -0.07879953942883663 +0.7018000000000001 0.6685918142850928 0.6685891652812828 4.5441560406200843e-07 -0.07880529721217285 +0.7019000000000001 0.6686025813057654 0.668599922492068 4.3967622014029484e-07 -0.07881105361708574 +0.702 0.6686133454260932 0.6686106771035497 4.2483988794972394e-07 -0.07881680864380461 +0.7021000000000001 0.6686241066456754 0.6686214291172513 4.0990968017129426e-07 -0.07882256229255885 +0.7022 0.6686348649641434 0.6686321785346648 3.9488868858184034e-07 -0.07882831456357786 +0.7023 0.6686456203811597 0.6686429253572508 3.797800234642268e-07 -0.07883406545709104 +0.7024000000000001 0.6686563728964184 0.6686536695864375 3.6458681291345885e-07 -0.07883981497332776 +0.7025 0.6686671225096459 0.6686644112236217 3.49312202274632e-07 -0.07884556311251746 +0.7026 0.6686778692206 0.668675150270168 3.3395935338659255e-07 -0.0788513098748896 +0.7027 0.6686886130290712 0.6686858867274085 3.185314439921316e-07 -0.0788570552606736 +0.7028000000000001 0.6686993539348823 0.6686966205966433 3.0303166709266804e-07 -0.07886279927009898 +0.7029000000000001 0.6687100919378884 0.6687073518791398 2.874632302057867e-07 -0.07886854190339526 +0.703 0.6687208270379773 0.6687180805761322 2.7182935481012693e-07 -0.07887428316079192 +0.7031000000000001 0.6687315592350696 0.6687288066888227 2.561332755959822e-07 -0.07888002304251851 +0.7032 0.668742288529119 0.6687395302183795 2.4037823980610495e-07 -0.07888576154880456 +0.7033 0.668753014920112 0.6687502511659384 2.2456750665283964e-07 -0.07889149867987966 +0.7034000000000001 0.6687637384080682 0.6687609695326019 2.087043465340277e-07 -0.07889723443597332 +0.7035 0.6687744589930408 0.6687716853194385 1.9279204040156817e-07 -0.07890296881731522 +0.7036 0.668785176675116 0.6687823985274843 1.7683387907446724e-07 -0.07890870182413491 +0.7037 0.6687958914544139 0.6687931091577413 1.608331625796433e-07 -0.0789144334566621 +0.7038000000000001 0.6688066033310879 0.6688038172111773 1.4479319945456814e-07 -0.07892016371512639 +0.7039000000000001 0.6688173123053248 0.6688145226887272 1.2871730603256082e-07 -0.07892589259975741 +0.704 0.6688280183773457 0.6688252255912923 1.1260880583910393e-07 -0.07893162011078492 +0.7041000000000001 0.6688387215474048 0.6688359259197392 9.647102882509584e-08 -0.07893734624843857 +0.7042 0.6688494218157908 0.6688466236749011 8.030731072500297e-08 -0.0789430710129481 +0.7043 0.6688601191828258 0.668857318857577 6.412099234215374e-08 -0.07894879440454323 +0.7044000000000001 0.6688708136488662 0.6688680114685323 4.791541884444084e-08 -0.0789545164234537 +0.7045 0.668881505214302 0.6688787015084976 3.169393912941243e-08 -0.0789602370699093 +0.7046 0.6688921938795576 0.66888938897817 1.5459905080075775e-08 -0.07896595634413976 +0.7047 0.6689028796450913 0.6689000738782124 -7.833291116449148e-10 -0.07897167424637494 +0.7048000000000001 0.6689135625113953 0.6689107562092534 -1.7032407632726343e-08 -0.07897739077684464 +0.7049000000000001 0.6689242424789963 0.6689214359718875 -3.328397374683864e-08 -0.07898310593577867 +0.705 0.6689349195484549 0.668932113166675 -4.9534670490728426e-08 -0.07898881972340692 +0.7051000000000001 0.6689455937203653 0.6689427877941422 -6.578114136344612e-08 -0.07899453213995919 +0.7052 0.6689562649953565 0.6689534598547808 -8.202003102131955e-08 -0.07900024318566541 +0.7053 0.6689669333740911 0.668964129349049 -9.824798597509593e-08 -0.07900595286075544 +0.7054000000000001 0.6689775988572658 0.6689747962773704 -1.1446165527548291e-07 -0.07901166116545921 +0.7055 0.6689882614456116 0.6689854606401351 -1.3065769121495263e-07 -0.07901736810000669 +0.7056 0.668998921139893 0.6689961224376981 -1.4683275001599327e-07 -0.07902307366462771 +0.7057 0.6690095779409088 0.6690067816703815 -1.629834925145901e-07 -0.07902877785955235 +0.7058000000000001 0.6690202318494916 0.669017438338473 -1.7910658485845166e-07 -0.07903448068501054 +0.7059000000000001 0.6690308828665075 0.6690280924422265 -1.9519869920783806e-07 -0.07904018214123226 +0.706 0.6690415309928568 0.6690387439818617 -2.1125651437567394e-07 -0.07904588222844755 +0.7061000000000001 0.669052176229473 0.6690493929575648 -2.2727671658562265e-07 -0.07905158094688637 +0.7062 0.6690628185773239 0.6690600393694885 -2.432560000792394e-07 -0.07905727829677883 +0.7063 0.6690734580374098 0.669070683217752 -2.591910678931275e-07 -0.07906297427835492 +0.7064000000000001 0.6690840946107656 0.6690813245024404 -2.750786324279275e-07 -0.07906866889184479 +0.7065 0.6690947282984586 0.6690919632236061 -2.9091541618730954e-07 -0.07907436213747851 +0.7066 0.6691053591015899 0.6691025993812676 -3.0669815254125155e-07 -0.07908005401548615 +0.7067 0.6691159870212929 0.6691132329754108 -3.2242358618400635e-07 -0.07908574452609786 +0.7068000000000001 0.6691266120587349 0.6691238640059878 -3.380884740500356e-07 -0.07909143366954373 +0.7069000000000001 0.6691372342151156 0.6691344924729187 -3.5368958574422127e-07 -0.07909712144605395 +0.707 0.6691478534916673 0.6691451183760899 -3.692237044577995e-07 -0.07910280785585865 +0.7071000000000001 0.6691584698896551 0.6691557417153561 -3.8468762744020557e-07 -0.07910849289918803 +0.7072 0.6691690834103764 0.6691663624905383 -4.000781667484743e-07 -0.07911417657627229 +0.7073 0.6691796940551612 0.6691769807014263 -4.1539214988561834e-07 -0.07911985888734163 +0.7074000000000001 0.6691903018253711 0.6691875963477771 -4.306264204737009e-07 -0.07912553983262631 +0.7075 0.6692009067223997 0.669198209429316 -4.4577783883670286e-07 -0.07913121941235653 +0.7076 0.669211508747673 0.6692088199457358 -4.608432827707398e-07 -0.07913689762676256 +0.7077 0.6692221079026479 0.6692194278966985 -4.758196480506016e-07 -0.0791425744760747 +0.7078000000000001 0.669232704188813 0.6692300332818342 -4.907038491791527e-07 -0.07914824996052323 +0.7079000000000001 0.669243297607688 0.6692406361007417 -5.054928200187714e-07 -0.07915392408033846 +0.708 0.6692538881608235 0.6692512363529883 -5.201835143464617e-07 -0.07915959683575065 +0.7081000000000001 0.6692644758498016 0.6692618340381116 -5.347729064714146e-07 -0.07916526822699023 +0.7082 0.6692750606762338 0.6692724291556171 -5.492579920191032e-07 -0.07917093825428746 +0.7083 0.6692856426417629 0.669283021704981 -5.636357884031273e-07 -0.07917660691787276 +0.7084000000000001 0.6692962217480616 0.6692936116856485 -5.779033355052254e-07 -0.07918227421797651 +0.7085 0.6693067979968321 0.6693041990970352 -5.920576962303858e-07 -0.07918794015482905 +0.7086 0.6693173713898071 0.6693147839385272 -6.060959571313473e-07 -0.07919360472866083 +0.7087 0.6693279419287481 0.6693253662094805 -6.200152291163663e-07 -0.0791992679397023 +0.7088000000000001 0.6693385096154458 0.6693359459092223 -6.338126479071837e-07 -0.07920492978818391 +0.7089000000000001 0.6693490744517199 0.6693465230370504 -6.4748537463577e-07 -0.07921059027433602 +0.709 0.6693596364394189 0.669357097592234 -6.610305966631147e-07 -0.07921624939838913 +0.7091000000000001 0.6693701955804195 0.6693676695740144 -6.744455277041261e-07 -0.07922190716057381 +0.7092 0.6693807518766268 0.6693782389816036 -6.877274088268326e-07 -0.07922756356112047 +0.7093 0.6693913053299734 0.6693888058141868 -7.008735088409601e-07 -0.07923321860025964 +0.7094000000000001 0.6694018559424195 0.6693993700709211 -7.138811248946775e-07 -0.07923887227822188 +0.7095 0.6694124037159528 0.6694099317509359 -7.267475830435854e-07 -0.0792445245952377 +0.7096 0.6694229486525877 0.6694204908533342 -7.394702387086838e-07 -0.07925017555153771 +0.7097 0.6694334907543652 0.6694310473771917 -7.520464773841384e-07 -0.07925582514735241 +0.7098000000000001 0.6694440300233528 0.669441601321558 -7.64473715067493e-07 -0.07926147338291238 +0.7099000000000001 0.6694545664616445 0.6694521526854569 -7.767493987315133e-07 -0.07926712025844834 +0.71 0.6694651000713592 0.6694627014678856 -7.88871007087466e-07 -0.07927276577419082 +0.7101000000000001 0.6694756308546412 0.6694732476678164 -8.008360506822632e-07 -0.07927840993037043 +0.7102 0.6694861588136609 0.6694837912841962 -8.126420730086847e-07 -0.07928405272721788 +0.7103 0.6694966839506118 0.6694943323159475 -8.242866505331348e-07 -0.07928969416496369 +0.7104000000000001 0.6695072062677134 0.6695048707619677 -8.357673933895304e-07 -0.07929533424383871 +0.7105 0.6695177257672085 0.6695154066211306 -8.470819456291023e-07 -0.07930097296407355 +0.7106 0.6695282424513633 0.6695259398922863 -8.58227986233473e-07 -0.07930661032589892 +0.7107 0.6695387563224677 0.6695364705742609 -8.692032290730234e-07 -0.07931224632954552 +0.7108000000000001 0.6695492673828347 0.669546998665858 -8.800054236562938e-07 -0.07931788097524409 +0.7109000000000001 0.6695597756347995 0.6695575241658579 -8.906323553242723e-07 -0.07932351426322534 +0.711 0.66957028108072 0.6695680470730193 -9.010818461246961e-07 -0.07932914619372007 +0.7111000000000001 0.6695807837229757 0.6695785673860786 -9.113517548259287e-07 -0.07933477676695908 +0.7112 0.6695912835639677 0.6695890851037508 -9.214399777357496e-07 -0.07934040598317313 +0.7113 0.6696017806061179 0.6695996002247293 -9.313444488678879e-07 -0.07934603384259299 +0.7114000000000001 0.6696122748518694 0.6696101127476868 -9.410631404693781e-07 -0.07935166034544949 +0.7115 0.6696227663036849 0.669620622671276 -9.505940634924048e-07 -0.07935728549197345 +0.7116 0.6696332549640482 0.6696311299941294 -9.599352678579809e-07 -0.07936290928239575 +0.7117 0.6696437408354616 0.6696416347148597 -9.690848429555476e-07 -0.07936853171694724 +0.7118000000000001 0.6696542239204468 0.6696521368320607 -9.78040918031553e-07 -0.07937415279585874 +0.7119000000000001 0.6696647042215443 0.669662636344307 -9.868016626057852e-07 -0.07937977251936121 +0.712 0.6696751817413127 0.6696731332501551 -9.95365286637906e-07 -0.07938539088768545 +0.7121000000000001 0.669685656482329 0.6696836275481435 -1.0037300413046069e-06 -0.07939100790106246 +0.7122 0.6696961284471874 0.6696941192367927 -1.0118942189440983e-06 -0.07939662355972311 +0.7123 0.6697065976384987 0.6697046083146072 -1.019856153777754e-06 -0.07940223786389838 +0.7124000000000001 0.669717064058891 0.6697150947800736 -1.0276142217713335e-06 -0.0794078508138192 +0.7125 0.6697275277110081 0.6697255786316629 -1.0351668414676496e-06 -0.07941346240971653 +0.7126 0.66973798859751 0.6697360598678298 -1.0425124739310565e-06 -0.07941907265182135 +0.7127 0.6697484467210717 0.669746538487014 -1.0496496234135844e-06 -0.0794246815403647 +0.7128000000000001 0.6697589020843832 0.6697570144876399 -1.0565768374382056e-06 -0.07943028907557752 +0.7129000000000001 0.6697693546901489 0.6697674878681178 -1.0632927071041465e-06 -0.07943589525769086 +0.713 0.669779804541087 0.6697779586268435 -1.069795867336687e-06 -0.07944150008693576 +0.7131000000000001 0.6697902516399296 0.6697884267621995 -1.0760849973312503e-06 -0.07944710356354327 +0.7132000000000001 0.6698006959894218 0.669798892272555 -1.0821588207476918e-06 -0.07945270568774446 +0.7133 0.669811137592321 0.6698093551562662 -1.0880161059323434e-06 -0.07945830645977035 +0.7134000000000001 0.6698215764513976 0.6698198154116772 -1.0936556661400587e-06 -0.07946390587985208 +0.7135 0.6698320125694328 0.6698302730371205 -1.099076359950546e-06 -0.07946950394822068 +0.7136 0.6698424459492194 0.6698407280309171 -1.1042770913516353e-06 -0.07947510066510732 +0.7137 0.669852876593561 0.6698511803913774 -1.1092568097947897e-06 -0.0794806960307431 +0.7138000000000001 0.669863304505272 0.6698616301168007 -1.1140145110555277e-06 -0.07948629004535923 +0.7139000000000001 0.6698737296871755 0.6698720772054769 -1.11854923656729e-06 -0.07949188270918676 +0.714 0.6698841521421055 0.6698825216556863 -1.1228600743096173e-06 -0.0794974740224569 +0.7141000000000001 0.6698945718729039 0.6698929634657005 -1.1269461585583507e-06 -0.07950306398540087 +0.7142000000000001 0.6699049888824212 0.6699034026337816 -1.1308066703297204e-06 -0.0795086525982498 +0.7143 0.669915403173516 0.6699138391581847 -1.1344408374358572e-06 -0.07951423986123489 +0.7144000000000001 0.6699258147490545 0.6699242730371568 -1.1378479347345927e-06 -0.07951982577458744 +0.7145 0.6699362236119096 0.6699347042689383 -1.1410272841017033e-06 -0.0795254103385386 +0.7146 0.6699466297649609 0.669945132851762 -1.143978254680711e-06 -0.0795309935533196 +0.7147 0.669957033211094 0.6699555587838554 -1.146700262993905e-06 -0.07953657541916172 +0.7148000000000001 0.6699674339532007 0.6699659820634404 -1.1491927731921425e-06 -0.07954215593629632 +0.7149000000000001 0.6699778319941765 0.6699764026887333 -1.1514552968605596e-06 -0.0795477351049546 +0.715 0.6699882273369226 0.6699868206579455 -1.1534873933516376e-06 -0.07955331292536778 +0.7151000000000001 0.6699986199843444 0.669997235969285 -1.1552886698684706e-06 -0.07955888939776729 +0.7152000000000001 0.6700090099393501 0.6700076486209552 -1.1568587814092535e-06 -0.0795644645223844 +0.7153 0.6700193972048516 0.6700180586111573 -1.1581974310448384e-06 -0.07957003829945047 +0.7154 0.6700297817837633 0.6700284659380888 -1.1593043696689342e-06 -0.07957561072919679 +0.7155 0.6700401636790017 0.6700388705999456 -1.1601793964144402e-06 -0.07958118181185475 +0.7156 0.6700505428934853 0.6700492725949213 -1.1608223584314015e-06 -0.0795867515476557 +0.7157 0.6700609194301332 0.6700596719212086 -1.1612331509147644e-06 -0.07959231993683101 +0.7158000000000001 0.6700712932918658 0.6700700685769997 -1.1614117173264216e-06 -0.07959788697961213 +0.7159000000000001 0.6700816644816033 0.6700804625604857 -1.161358049284189e-06 -0.07960345267623044 +0.716 0.6700920330022657 0.6700908538698586 -1.1610721863397622e-06 -0.07960901702691733 +0.7161000000000001 0.6701023988567723 0.6701012425033107 -1.1605542163117821e-06 -0.07961458003190425 +0.7162000000000001 0.6701127620480409 0.6701116284590357 -1.1598042751748139e-06 -0.07962014169142262 +0.7163 0.6701231225789879 0.6701220117352291 -1.1588225470315905e-06 -0.07962570200570393 +0.7164 0.6701334804525272 0.6701323923300885 -1.157609263863213e-06 -0.07963126097497965 +0.7165 0.67014383567157 0.6701427702418138 -1.1561647056956836e-06 -0.07963681859948124 +0.7166 0.6701541882390243 0.6701531454686085 -1.1544892005721508e-06 -0.07964237487944022 +0.7167 0.6701645381577943 0.6701635180086796 -1.1525831243863749e-06 -0.07964792981508811 +0.7168000000000001 0.6701748854307801 0.6701738878602376 -1.15044690068844e-06 -0.07965348340665634 +0.7169000000000001 0.6701852300608772 0.6701842550214985 -1.1480810007680198e-06 -0.0796590356543765 +0.717 0.6701955720509756 0.670194619490683 -1.1454859436543785e-06 -0.07966458655848013 +0.7171000000000001 0.67020591140396 0.6702049812660176 -1.1426622956167698e-06 -0.07967013611919878 +0.7172000000000001 0.6702162481227087 0.6702153403457344 -1.1396106703309705e-06 -0.079675684336764 +0.7173 0.6702265822100935 0.6702256967280724 -1.1363317288515251e-06 -0.07968123121140737 +0.7174 0.6702369136689788 0.6702360504112775 -1.132826179250923e-06 -0.07968677674336047 +0.7175 0.6702472425022221 0.6702464013936031 -1.129094776369799e-06 -0.07969232093285494 +0.7176 0.6702575687126723 0.6702567496733106 -1.1251383220389766e-06 -0.07969786378012234 +0.7177 0.6702678923031697 0.6702670952486698 -1.1209576646908914e-06 -0.07970340528539434 +0.7178000000000001 0.670278213276546 0.6702774381179594 -1.1165536989710123e-06 -0.07970894544890252 +0.7179000000000001 0.6702885316356231 0.6702877782794676 -1.1119273659876416e-06 -0.07971448427087854 +0.718 0.670298847383213 0.6702981157314924 -1.1070796527568039e-06 -0.07972002175155413 +0.7181000000000001 0.6703091605221173 0.6703084504723422 -1.1020115923132678e-06 -0.07972555789116086 +0.7182000000000001 0.6703194710551269 0.670318782500336 -1.0967242631276797e-06 -0.07973109268993045 +0.7183 0.670329778985021 0.6703291118138042 -1.091218788967785e-06 -0.0797366261480946 +0.7184 0.6703400843145675 0.6703394384110888 -1.0854963390927175e-06 -0.07974215826588503 +0.7185 0.6703503870465213 0.6703497622905443 -1.0795581273093102e-06 -0.07974768904353342 +0.7186 0.6703606871836254 0.6703600834505375 -1.073405412221895e-06 -0.07975321848127154 +0.7187 0.6703709847286088 0.6703704018894486 -1.067039496954747e-06 -0.07975874657933106 +0.7188000000000001 0.6703812796841874 0.6703807176056709 -1.060461728596973e-06 -0.07976427333794378 +0.7189000000000001 0.6703915720530632 0.6703910305976118 -1.0536734981470008e-06 -0.07976979875734146 +0.719 0.6704018618379233 0.6704013408636937 -1.046676239957467e-06 -0.07977532283775587 +0.7191000000000001 0.6704121490414399 0.6704116484023532 -1.0394714319850173e-06 -0.07978084557941881 +0.7192000000000001 0.6704224336662697 0.6704219532120425 -1.0320605948743733e-06 -0.07978636698256203 +0.7193 0.670432715715054 0.6704322552912292 -1.024445291847309e-06 -0.0797918870474174 +0.7194 0.6704429951904175 0.6704425546383979 -1.0166271284806072e-06 -0.0797974057742167 +0.7195 0.6704532720949679 0.6704528512520488 -1.0086077522897252e-06 -0.07980292316319175 +0.7196 0.6704635464312961 0.6704631451306997 -1.0003888525345062e-06 -0.07980843921457438 +0.7197 0.6704738182019758 0.6704734362728859 -9.919721594697783e-07 -0.07981395392859646 +0.7198000000000001 0.6704840874095624 0.6704837246771604 -9.833594444841331e-07 -0.07981946730548986 +0.7199000000000001 0.6704943540565925 0.6704940103420945 -9.745525192395021e-07 -0.07982497934548641 +0.72 0.6705046181455847 0.6705042932662784 -9.65553235809935e-07 -0.07983049004881805 +0.7201000000000001 0.6705148796790381 0.6705145734483208 -9.56363485932199e-07 -0.07983599941571665 +0.7202000000000001 0.6705251386594322 0.6705248508868507 -9.469852005616897e-07 -0.07984150744641415 +0.7203 0.670535395089226 0.6705351255805164 -9.374203497058975e-07 -0.07984701414114237 +0.7204 0.6705456489708591 0.6705453975279869 -9.276709419803186e-07 -0.07985251950013333 +0.7205 0.6705559003067496 0.6705556667279514 -9.177390239978322e-07 -0.07985802352361893 +0.7206 0.6705661490992945 0.6705659331791207 -9.076266802299227e-07 -0.07986352621183108 +0.7207 0.6705763953508694 0.6705761968802267 -8.973360322711565e-07 -0.0798690275650018 +0.7208000000000001 0.6705866390638282 0.6705864578300238 -8.868692385477495e-07 -0.07987452758336305 +0.7209000000000001 0.6705968802405021 0.6705967160272878 -8.762284939289877e-07 -0.07988002626714685 +0.721 0.6706071188831999 0.6706069714708169 -8.654160292415058e-07 -0.07988552361658513 +0.7211000000000001 0.6706173549942072 0.6706172241594331 -8.544341105753972e-07 -0.07989101963190987 +0.7212000000000001 0.6706275885757862 0.6706274740919813 -8.432850391593139e-07 -0.0798965143133531 +0.7213 0.6706378196301755 0.6706377212673301 -8.319711506526994e-07 -0.07990200766114691 +0.7214 0.6706480481595898 0.670647965684372 -8.204948146461888e-07 -0.0799074996755233 +0.7215 0.6706582741662188 0.6706582073420237 -8.088584343424188e-07 -0.07991299035671424 +0.7216 0.6706684976522277 0.670668446239227 -7.970644458898946e-07 -0.07991847970495188 +0.7217 0.6706787186197571 0.670678682374948 -7.851153179666559e-07 -0.07992396772046823 +0.7218000000000001 0.6706889370709213 0.6706889157481792 -7.73013551266799e-07 -0.07992945440349537 +0.7219000000000001 0.6706991530078095 0.6706991463579377 -7.607616779037318e-07 -0.07993493975426541 +0.722 0.6707093664324844 0.6707093742032674 -7.483622609938401e-07 -0.07994042377301042 +0.7221000000000001 0.6707195773469828 0.6707195992832379 -7.358178938793314e-07 -0.07994590645996252 +0.7222000000000001 0.6707297857533145 0.6707298215969455 -7.231311999617018e-07 -0.07995138781535382 +0.7223 0.6707399916534621 0.6707400411435139 -7.103048319384575e-07 -0.07995686783941647 +0.7224 0.6707501950493814 0.6707502579220935 -6.97341471053714e-07 -0.07996234653238259 +0.7225 0.6707603959430002 0.6707604719318621 -6.842438270426854e-07 -0.07996782389448427 +0.7226 0.6707705943362187 0.6707706831720257 -6.710146370908499e-07 -0.07997329992595376 +0.7227 0.6707807902309088 0.6707808916418182 -6.576566655008831e-07 -0.07997877462702319 +0.7228000000000001 0.6707909836289142 0.6707910973405015 -6.441727030681577e-07 -0.0799842479979247 +0.7229000000000001 0.6708011745320499 0.6708013002673663 -6.30565566428487e-07 -0.0799897200388905 +0.723 0.6708113629421015 0.6708115004217323 -6.168380976556698e-07 -0.07999519075015282 +0.7231000000000001 0.6708215488608259 0.670821697802948 -6.029931634982111e-07 -0.08000066013194378 +0.7232000000000001 0.6708317322899506 0.6708318924103915 -5.890336548797226e-07 -0.08000612818449565 +0.7233 0.6708419132311734 0.6708420842434708 -5.749624862050329e-07 -0.08001159490804072 +0.7234 0.6708520916861617 0.6708522733016229 -5.607825947911982e-07 -0.08001706030281114 +0.7235 0.6708622676565531 0.6708624595843153 -5.464969402013686e-07 -0.08002252436903917 +0.7236 0.670872441143955 0.6708726430910458 -5.321085038839657e-07 -0.08002798710695708 +0.7237 0.6708826121499436 0.6708828238213427 -5.176202881596037e-07 -0.08003344851679711 +0.7238000000000001 0.6708927806760652 0.6708930017747649 -5.030353159435341e-07 -0.08003890859879155 +0.7239000000000001 0.6709029467238343 0.6709031769509022 -4.883566298713449e-07 -0.08004436735317266 +0.724 0.6709131102947348 0.6709133493493757 -4.735872918132378e-07 -0.08004982478017278 +0.7241000000000001 0.6709232713902187 0.6709235189698379 -4.587303821523836e-07 -0.0800552808800242 +0.7242000000000001 0.6709334300117068 0.6709336858119722 -4.437889992298105e-07 -0.08006073565295921 +0.7243 0.670943586160588 0.6709438498754942 -4.2876625856030914e-07 -0.08006618909921015 +0.7244 0.6709537398382192 0.6709540111601511 -4.13665292339771e-07 -0.08007164121900934 +0.7245 0.670963891045925 0.6709641696657223 -3.984892486749714e-07 -0.0800770920125891 +0.7246 0.6709740397849985 0.670974325392019 -3.8324129101457993e-07 -0.08008254148018183 +0.7247 0.6709841860566995 0.6709844783388852 -3.679245974413936e-07 -0.08008798962201985 +0.7248000000000001 0.6709943298622558 0.670994628506197 -3.525423599576305e-07 -0.08009343643833557 +0.7249000000000001 0.6710044712028624 0.6710047758938631 -3.3709778395757395e-07 -0.08009888192936129 +0.725 0.6710146100796818 0.671014920501825 -3.215940874504164e-07 -0.08010432609532951 +0.7251000000000001 0.6710247464938425 0.6710250623300573 -3.0603450044269787e-07 -0.08010976893647254 +0.7252000000000001 0.671034880446441 0.671035201378567 -2.9042226423747763e-07 -0.08011521045302278 +0.7253000000000001 0.6710450119385404 0.671045337647395 -2.7476063076820045e-07 -0.08012065064521272 +0.7254 0.6710551409711702 0.6710554711366143 -2.5905286191868493e-07 -0.08012608951327471 +0.7255 0.6710652675453268 0.6710656018463322 -2.433022288569897e-07 -0.0801315270574412 +0.7256 0.6710753916619729 0.6710757297766887 -2.275120113345852e-07 -0.08013696327794467 +0.7257 0.6710855133220381 0.6710858549278577 -2.116854970306281e-07 -0.08014239817501752 +0.7258000000000001 0.6710956325264179 0.6710959773000463 -1.958259808199081e-07 -0.08014783174889223 +0.7259000000000001 0.6711057492759743 0.6711060968934955 -1.7993676417610294e-07 -0.0801532639998013 +0.726 0.6711158635715354 0.6711162137084796 -1.6402115435298903e-07 -0.08015869492797717 +0.7261 0.671125975413896 0.671126327745307 -1.4808246383279933e-07 -0.08016412453365235 +0.7262000000000001 0.671136084803816 0.6711364390043195 -1.3212400954906722e-07 -0.08016955281705929 +0.7263000000000001 0.6711461917420225 0.6711465474858931 -1.1614911222049273e-07 -0.08017497977843051 +0.7264 0.6711562962292085 0.6711566531904373 -1.0016109567266562e-07 -0.08018040541799859 +0.7265 0.6711663982660321 0.6711667561183956 -8.416328612335933e-08 -0.08018582973599597 +0.7266 0.6711764978531183 0.6711768562702453 -6.815901150772352e-08 -0.08019125273265518 +0.7267 0.6711865949910584 0.6711869536464978 -5.215160077485376e-08 -0.08019667440820884 +0.7268000000000001 0.6711966896804085 0.6711970482476983 -3.614438320702091e-08 -0.08020209476288945 +0.7269000000000001 0.6712067819216914 0.671207140074426 -2.0140687716132394e-08 -0.08020751379692953 +0.727 0.6712168717153961 0.6712172291272933 -4.143842156564825e-09 -0.08021293151056166 +0.7271 0.6712269590619775 0.6712273154069477 1.1842827369809572e-08 -0.08021834790401844 +0.7272000000000001 0.6712370439618559 0.6712373989140699 2.7815997205235532e-08 -0.08022376297753242 +0.7273000000000001 0.6712471264154188 0.6712474796493741 4.377234682356734e-08 -0.08022917673133621 +0.7274 0.6712572064230192 0.6712575576136092 5.970855951852039e-08 -0.08023458916566245 +0.7275 0.6712672839849764 0.6712676328075569 7.56213231097036e-08 -0.0802400002807437 +0.7276 0.6712773591015754 0.6712777052320331 9.15073306261005e-08 -0.08024541007681259 +0.7277 0.6712874317730679 0.6712877748878874 1.0736328097046832e-07 -0.08025081855410172 +0.7278000000000001 0.6712975019996721 0.6712978417760028 1.2318587962883987e-07 -0.08025622571284377 +0.7279000000000001 0.6713075697815718 0.6713079058972958 1.389718393696171e-07 -0.08026163155327135 +0.728 0.6713176351189184 0.6713179672527164 1.5471788089582716e-07 -0.0802670360756171 +0.7281 0.6713276980118291 0.6713280258432477 1.7042073352166454e-07 -0.08027243928011364 +0.7282000000000001 0.6713377584603882 0.6713380816699065 1.8607713590454433e-07 -0.08027784116699371 +0.7283000000000001 0.6713478164646464 0.6713481347337426 2.0168383666613332e-07 -0.08028324173648999 +0.7284 0.6713578720246212 0.6713581850358386 2.172375951001171e-07 -0.0802886409888351 +0.7285 0.6713679251402974 0.67136823257731 2.327351818556811e-07 -0.08029403892426178 +0.7286 0.6713779758116266 0.6713782773593057 2.4817337955507224e-07 -0.08029943554300267 +0.7287 0.671388024038528 0.6713883193830067 2.635489834840188e-07 -0.08030483084529054 +0.7288000000000001 0.6713980698208879 0.6713983586496268 2.788588023619476e-07 -0.08031022483135808 +0.7289000000000001 0.6714081131585599 0.6714083951604122 2.940996588415845e-07 -0.08031561750143801 +0.729 0.6714181540513653 0.6714184289166412 3.0926839027223263e-07 -0.08032100885576303 +0.7291 0.6714281924990936 0.6714284599196241 3.2436184929651724e-07 -0.08032639889456589 +0.7292000000000001 0.6714382285015019 0.6714384881707036 3.3937690457896963e-07 -0.08033178761807934 +0.7293000000000001 0.6714482620583156 0.6714485136712542 3.543104413958331e-07 -0.08033717502653615 +0.7294 0.6714582931692283 0.6714585364226813 3.6915936228731905e-07 -0.08034256112016908 +0.7295 0.6714683218339021 0.6714685564264227 3.839205877514962e-07 -0.0803479458992109 +0.7296 0.6714783480519677 0.6714785736839465 3.985910568410356e-07 -0.08035332936389439 +0.7297 0.6714883718230248 0.6714885881967523 4.1316772776689437e-07 -0.0803587115144523 +0.7298000000000001 0.6714983931466417 0.6714985999663705 4.2764757857138846e-07 -0.08036409235111741 +0.7299000000000001 0.6715084120223567 0.6715086089943626 4.4202760782208195e-07 -0.08036947187412258 +0.73 0.6715184284496769 0.6715186152823197 4.563048351113874e-07 -0.08037485008370057 +0.7301 0.6715284424280796 0.6715286188318637 4.704763017504554e-07 -0.08038022698008424 +0.7302000000000001 0.6715384539570117 0.671538619644646 4.845390713520414e-07 -0.08038560256350635 +0.7303000000000001 0.6715484630358903 0.6715486177223483 4.984902304688843e-07 -0.08039097683419977 +0.7304 0.6715584696641035 0.6715586130666813 5.123268891904509e-07 -0.08039634979239735 +0.7305 0.6715684738410089 0.6715686056793855 5.260461817396811e-07 -0.08040172143833191 +0.7306 0.6715784755659358 0.6715785955622299 5.396452670142216e-07 -0.0804070917722363 +0.7307 0.6715884748381843 0.6715885827170122 5.531213293358261e-07 -0.08041246079434333 +0.7308000000000001 0.671598471657026 0.6715985671455595 5.664715788389341e-07 -0.08041782850488598 +0.7309000000000001 0.6716084660217044 0.6716085488497263 5.796932521506815e-07 -0.08042319490409705 +0.731 0.6716184579314346 0.6716185278313951 5.927836129460129e-07 -0.08042855999220945 +0.7311 0.671628447385404 0.6716285040924765 6.057399525166707e-07 -0.08043392376945602 +0.7312000000000001 0.6716384343827726 0.6716384776349079 6.185595904095731e-07 -0.08043928623606968 +0.7313000000000001 0.671648418922673 0.6716484484606544 6.312398748709036e-07 -0.08044464739228332 +0.7314 0.6716584010042114 0.6716584165717074 6.437781833734668e-07 -0.08045000723832986 +0.7315 0.6716683806264668 0.6716683819700855 6.561719233383334e-07 -0.08045536577444225 +0.7316 0.6716783577884922 0.6716783446578327 6.684185324540293e-07 -0.08046072300085336 +0.7317 0.6716883324893147 0.6716883046370195 6.805154793981805e-07 -0.08046607891779613 +0.7318000000000001 0.6716983047279355 0.6716982619097414 6.924602642122135e-07 -0.08047143352550355 +0.7319000000000001 0.6717082745033307 0.6717082164781196 7.04250418981367e-07 -0.08047678682420852 +0.732 0.6717182418144514 0.6717181683443001 7.158835081538806e-07 -0.08048213881414401 +0.7321 0.6717282066602235 0.6717281175104532 7.273571291377401e-07 -0.08048748949554296 +0.7322000000000001 0.6717381690395494 0.6717380639787739 7.386689129390556e-07 -0.08049283886863837 +0.7323000000000001 0.6717481289513072 0.6717480077514806 7.49816524384106e-07 -0.0804981869336632 +0.7324 0.6717580863943508 0.6717579488308154 7.607976627854729e-07 -0.08050353369085035 +0.7325 0.6717680413675116 0.6717678872190438 7.716100623306188e-07 -0.0805088791404329 +0.7326 0.6717779938695975 0.6717778229184539 7.822514927757762e-07 -0.08051422328264382 +0.7327 0.6717879438993943 0.6717877559313563 7.927197594598256e-07 -0.0805195661177161 +0.7328000000000001 0.6717978914556653 0.6717976862600838 8.03012704192474e-07 -0.08052490764588272 +0.7329000000000001 0.6718078365371521 0.6718076139069911 8.131282055318101e-07 -0.08053024786737673 +0.733 0.671817779142575 0.6718175388744536 8.230641791728832e-07 -0.08053558678243117 +0.7331 0.6718277192706328 0.6718274611648679 8.328185784056696e-07 -0.08054092439127897 +0.7332000000000001 0.6718376569200042 0.6718373807806516 8.423893946979399e-07 -0.08054626069415326 +0.7333000000000001 0.6718475920893473 0.671847297724242 8.517746578062813e-07 -0.08055159569128703 +0.7334 0.6718575247773003 0.6718572119980964 8.6097243651162e-07 -0.08055692938291331 +0.7335 0.6718674549824822 0.6718671236046918 8.699808387579999e-07 -0.08056226176926524 +0.7336 0.6718773827034923 0.6718770325465233 8.787980122493266e-07 -0.0805675928505758 +0.7337 0.6718873079389122 0.6718869388261054 8.874221446297792e-07 -0.08057292262707808 +0.7338000000000001 0.671897230687304 0.6718968424459703 8.958514640389215e-07 -0.08057825109900509 +0.7339000000000001 0.6719071509472132 0.6719067434086681 9.040842393615023e-07 -0.08058357826659 +0.734 0.6719170687171669 0.6719166417167663 9.121187806715447e-07 -0.08058890413006586 +0.7341 0.6719269839956759 0.6719265373728492 9.199534395376574e-07 -0.0805942286896657 +0.7342000000000001 0.671936896781234 0.6719364303795179 9.275866092728347e-07 -0.08059955194562274 +0.7343000000000001 0.671946807072319 0.6719463207393888 9.350167254340569e-07 -0.08060487389816999 +0.7344 0.6719567148673928 0.6719562084550943 9.422422660443353e-07 -0.08061019454754054 +0.7345 0.6719666201649026 0.6719660935292824 9.492617518425117e-07 -0.08061551389396755 +0.7346 0.6719765229632798 0.6719759759646153 9.56073746949393e-07 -0.08062083193768414 +0.7347 0.6719864232609422 0.67198585576377 9.626768586457057e-07 -0.08062614867892344 +0.7348000000000001 0.6719963210562933 0.6719957329294366 9.690697380104751e-07 -0.08063146411791855 +0.7349000000000001 0.6720062163477232 0.6720056074643194 9.752510800042913e-07 -0.08063677825490262 +0.735 0.672016109133609 0.672015479371135 9.812196238578874e-07 -0.08064209109010881 +0.7351 0.6720259994123149 0.6720253486526133 9.869741534052068e-07 -0.08064740262377025 +0.7352000000000001 0.6720358871821934 0.6720352153114951 9.925134971111582e-07 -0.08065271285612013 +0.7353000000000001 0.6720457724415849 0.6720450793505337 9.978365284601942e-07 -0.08065802178739155 +0.7354 0.6720556551888187 0.6720549407724936 1.0029421661506e-06 -0.08066332941781772 +0.7355 0.6720655354222138 0.6720647995801491 1.0078293744275602e-06 -0.08066863574763183 +0.7356 0.6720754131400781 0.6720746557762853 1.012497163027648e-06 -0.080673940777067 +0.7357 0.6720852883407102 0.6720845093636973 1.0169445877339367e-06 -0.08067924450635647 +0.7358000000000001 0.6720951610223994 0.6720943603451888 1.0211707500984435e-06 -0.08068454693573344 +0.7359000000000001 0.6721050311834258 0.6721042087235727 1.0251747982470416e-06 -0.08068984806543107 +0.736 0.6721148988220609 0.6721140545016702 1.0289559265463932e-06 -0.08069514789568258 +0.7361 0.6721247639365688 0.6721238976823098 1.0325133759370164e-06 -0.08070044642672113 +0.7362000000000001 0.672134626525206 0.6721337382683283 1.0358464341830853e-06 -0.08070574365877999 +0.7363000000000001 0.6721444865862216 0.6721435762625686 1.0389544358446745e-06 -0.08071103959209235 +0.7364 0.6721543441178588 0.6721534116678805 1.041836762416537e-06 -0.08071633422689145 +0.7365 0.6721641991183545 0.6721632444871194 1.044492842661171e-06 -0.08072162756341053 +0.7366 0.67217405158594 0.6721730747231461 1.0469221526088202e-06 -0.0807269196018828 +0.7367 0.6721839015188413 0.6721829023788268 1.0491242155852287e-06 -0.08073221034254152 +0.7368000000000001 0.6721937489152807 0.6721927274570316 1.0510986023504199e-06 -0.08073749978561995 +0.7369000000000001 0.6722035937734756 0.6722025499606353 1.0528449312374732e-06 -0.08074278793135134 +0.737 0.6722134360916397 0.6722123698925154 1.054362868235792e-06 -0.08074807477996891 +0.7371 0.672223275867984 0.6722221872555527 1.055652127074369e-06 -0.08075336033170592 +0.7372000000000001 0.6722331131007171 0.6722320020526309 1.0567124689997431e-06 -0.08075864458679566 +0.7373000000000001 0.6722429477880446 0.6722418142866349 1.0575437032200874e-06 -0.08076392754547136 +0.7374 0.6722527799281715 0.6722516239604521 1.0581456867109207e-06 -0.08076920920796636 +0.7375 0.672262609519301 0.6722614310769707 1.0585183243261298e-06 -0.08077448957451393 +0.7376 0.6722724365596353 0.672271235639079 1.0586615687424583e-06 -0.08077976864534729 +0.7377 0.6722822610473778 0.672281037649666 1.05857542062604e-06 -0.08078504642069985 +0.7378000000000001 0.6722920829807304 0.6722908371116197 1.0582599283825989e-06 -0.08079032290080486 +0.7379000000000001 0.6723019023578969 0.6723006340278277 1.0577151883517377e-06 -0.08079559808589558 +0.738 0.6723117191770824 0.6723104284011758 1.0569413444461162e-06 -0.08080087197620534 +0.7381 0.6723215334364934 0.6723202202345484 1.0559385888453399e-06 -0.08080614457196748 +0.7382000000000001 0.6723313451343386 0.6723300095308271 1.0547071611355374e-06 -0.08081141587341531 +0.7383000000000001 0.6723411542688296 0.672339796292891 1.05324734875345e-06 -0.08081668588078211 +0.7384000000000001 0.6723509608381815 0.6723495805236157 1.0515594867643863e-06 -0.08082195459430129 +0.7385 0.6723607648406125 0.6723593622258728 1.049643957529156e-06 -0.0808272220142061 +0.7386 0.6723705662743455 0.6723691414025297 1.0475011912591814e-06 -0.0808324881407299 +0.7387 0.6723803651376083 0.6723789180564492 1.0451316653503628e-06 -0.08083775297410606 +0.7388000000000001 0.6723901614286332 0.6723886921904887 1.0425359046328797e-06 -0.08084301651456788 +0.7389000000000001 0.6723999551456586 0.6723984638074999 1.0397144808438341e-06 -0.08084827876234878 +0.739 0.672409746286929 0.672408232910328 1.0366680129325623e-06 -0.08085353971768205 +0.7391 0.6724195348506952 0.6724179995018118 1.0333971667830788e-06 -0.08085879938080108 +0.7392000000000001 0.6724293208352152 0.6724277635847828 1.0299026551585655e-06 -0.08086405775193921 +0.7393000000000001 0.6724391042387552 0.6724375251620649 1.0261852371740154e-06 -0.08086931483132985 +0.7394000000000001 0.6724488850595887 0.6724472842364737 1.0222457186293e-06 -0.08087457061920637 +0.7395 0.672458663295998 0.6724570408108164 1.0180849513707901e-06 -0.08087982511580218 +0.7396 0.6724684389462743 0.6724667948878906 1.0137038335411575e-06 -0.0808850783213506 +0.7397 0.6724782120087183 0.6724765464704852 1.0091033091630397e-06 -0.08089033023608508 +0.7398 0.6724879824816407 0.6724862955613775 1.0042843678614854e-06 -0.0808955808602389 +0.7399000000000001 0.6724977503633625 0.6724960421633361 9.992480449749763e-07 -0.08090083019404555 +0.74 0.6725075156522158 0.6725057862791177 9.939954209170487e-07 -0.0809060782377384 +0.7401 0.6725172783465436 0.672515527911468 9.885276212040495e-07 -0.0809113249915509 +0.7402000000000001 0.6725270384447011 0.6725252670631203 9.828458163441134e-07 -0.08091657045571644 +0.7403000000000001 0.6725367959450554 0.6725350037367959 9.769512212542963e-07 -0.08092181463046844 +0.7404000000000001 0.6725465508459867 0.672544737935203 9.708450950662861e-07 -0.08092705751604026 +0.7405 0.6725563031458877 0.6725544696610373 9.645287410153802e-07 -0.08093229911266542 +0.7406 0.672566052843165 0.6725641989169797 9.5800350616293e-07 -0.08093753942057723 +0.7407 0.6725757999362395 0.6725739257056982 9.512707810910292e-07 -0.08094277844000924 +0.7408 0.6725855444235463 0.6725836500298452 9.443319995972033e-07 -0.0809480161711948 +0.7409000000000001 0.6725952863035356 0.6725933718920583 9.371886381115413e-07 -0.08095325261436738 +0.741 0.6726050255746727 0.6726030912949602 9.298422158354747e-07 -0.08095848776976045 +0.7411 0.6726147622354388 0.6726128082411571 9.222942943254431e-07 -0.08096372163760743 +0.7412000000000001 0.6726244962843316 0.672622522733239 9.145464767157385e-07 -0.08096895421814178 +0.7413000000000001 0.6726342277198649 0.6726322347737792 9.066004081625945e-07 -0.08097418551159694 +0.7414000000000001 0.6726439565405699 0.672641944365334 8.984577747339628e-07 -0.08097941551820637 +0.7415 0.6726536827449954 0.6726516515104422 8.901203033817584e-07 -0.08098464423820358 +0.7416 0.6726634063317075 0.6726613562116239 8.815897618863477e-07 -0.08098987167182198 +0.7417 0.6726731272992914 0.6726710584713818 8.728679578018372e-07 -0.08099509781929506 +0.7418 0.6726828456463507 0.6726807582921988 8.639567386781177e-07 -0.08100032268085632 +0.7419000000000001 0.6726925613715076 0.672690455676539 8.548579913947307e-07 -0.08100554625673917 +0.742 0.6727022744734048 0.6727001506268474 8.455736417445348e-07 -0.08101076854717722 +0.7421 0.6727119849507042 0.6727098431455479 8.361056541700274e-07 -0.08101598955240383 +0.7422000000000001 0.672721692802088 0.6727195332350447 8.264560312082336e-07 -0.08102120927265252 +0.7423000000000001 0.6727313980262598 0.6727292208977215 8.166268131437615e-07 -0.08102642770815686 +0.7424000000000001 0.6727411006219433 0.6727389061359397 8.066200776479793e-07 -0.08103164485915025 +0.7425 0.6727508005878844 0.6727485889520401 7.964379391961485e-07 -0.08103686072586624 +0.7426 0.6727604979228506 0.6727582693483416 7.860825486649681e-07 -0.08104207530853835 +0.7427 0.6727701926256315 0.6727679473271397 7.75556092971752e-07 -0.08104728860740004 +0.7428 0.6727798846950392 0.6727776228907085 7.648607945609509e-07 -0.08105250062268486 +0.7429000000000001 0.6727895741299093 0.6727872960412984 7.539989107935297e-07 -0.0810577113546263 +0.743 0.6727992609290998 0.6727969667811369 7.429727337110448e-07 -0.08106292080345791 +0.7431 0.6728089450914929 0.6728066351124269 7.317845895221664e-07 -0.0810681289694132 +0.7432000000000001 0.6728186266159948 0.672816301037348 7.204368378393999e-07 -0.08107333585272566 +0.7433000000000001 0.6728283055015358 0.6728259645580552 7.089318715125525e-07 -0.08107854145362889 +0.7434000000000001 0.6728379817470709 0.6728356256766785 6.97272115920966e-07 -0.08108374577235633 +0.7435 0.6728476553515799 0.6728452843953229 6.854600286959611e-07 -0.08108894880914157 +0.7436 0.6728573263140686 0.672854940716068 6.734980987910255e-07 -0.08109415056421816 +0.7437 0.6728669946335675 0.6728645946409683 6.61388846356914e-07 -0.08109935103781962 +0.7438 0.6728766603091336 0.6728742461720512 6.491348221310256e-07 -0.08110455023017951 +0.7439000000000001 0.6728863233398503 0.6728838953113181 6.367386068267811e-07 -0.08110974814153138 +0.744 0.6728959837248268 0.6728935420607441 6.242028104536113e-07 -0.08111494477210873 +0.7441 0.6729056414632002 0.6729031864222775 6.115300720116457e-07 -0.08112014012214523 +0.7442000000000001 0.6729152965541336 0.6729128283978383 5.987230588394565e-07 -0.08112533419187432 +0.7443000000000001 0.6729249489968184 0.6729224679893199 5.857844661144584e-07 -0.08113052698152962 +0.7444000000000001 0.6729345987904735 0.6729321051985875 5.727170162145301e-07 -0.08113571849134465 +0.7445 0.6729442459343452 0.6729417400274784 5.595234581212694e-07 -0.08114090872155304 +0.7446 0.672953890427709 0.6729513724778019 5.462065668648819e-07 -0.08114609767238834 +0.7447 0.6729635322698683 0.6729610025513375 5.327691429551917e-07 -0.08115128534408407 +0.7448 0.6729731714601555 0.6729706302498369 5.192140119653077e-07 -0.08115647173687386 +0.7449000000000001 0.6729828079979316 0.6729802555750226 5.05544023574056e-07 -0.08116165685099128 +0.745 0.6729924418825876 0.672989878528587 4.917620512745469e-07 -0.08116684068666989 +0.7451 0.6730020731135431 0.6729994991121938 4.778709916247736e-07 -0.08117202324414328 +0.7452000000000001 0.6730117016902485 0.6730091173274764 4.6387376369250166e-07 -0.08117720452364509 +0.7453000000000001 0.6730213276121834 0.6730187331760378 4.497733084862787e-07 -0.08118238452540882 +0.7454000000000001 0.6730309508788574 0.6730283466594512 4.355725882199124e-07 -0.08118756324966815 +0.7455 0.6730405714898116 0.6730379577792592 4.2127458574348076e-07 -0.0811927406966566 +0.7456 0.6730501894446163 0.6730475665369737 4.0688230400209857e-07 -0.08119791686660782 +0.7457 0.6730598047428735 0.6730571729340757 3.923987652518224e-07 -0.08120309175975543 +0.7458 0.673069417384216 0.673066776972015 3.778270105184167e-07 -0.08120826537633297 +0.7459000000000001 0.6730790273683079 0.67307637865221 3.6317009899367036e-07 -0.08121343771657408 +0.746 0.6730886346948443 0.673085977976048 3.4843110734150695e-07 -0.08121860878071235 +0.7461 0.6730982393635518 0.6730955749448841 3.3361312899715667e-07 -0.08122377856898137 +0.7462000000000001 0.6731078413741896 0.6731051695600425 3.187192736814337e-07 -0.08122894708161485 +0.7463000000000001 0.6731174407265476 0.6731147618228142 3.03752666568069e-07 -0.08123411431884629 +0.7464000000000001 0.6731270374204483 0.6731243517344588 2.887164477563542e-07 -0.08123928028090935 +0.7465 0.6731366314557468 0.673133939296204 2.7361377154255795e-07 -0.0812444449680377 +0.7466 0.6731462228323293 0.6731435245092443 2.584478057676698e-07 -0.08124960838046491 +0.7467 0.6731558115501155 0.6731531073747419 2.432217311928997e-07 -0.08125477051842461 +0.7468 0.6731653976090575 0.6731626878938264 2.279387407988498e-07 -0.08125993138215042 +0.7469000000000001 0.6731749810091399 0.6731722660675946 2.1260203913325837e-07 -0.08126509097187601 +0.747 0.6731845617503799 0.6731818418971105 1.9721484160323266e-07 -0.08127024928783498 +0.7471 0.6731941398328279 0.6731914153834048 1.817803738507484e-07 -0.08127540633026095 +0.7472000000000001 0.6732037152565675 0.6732009865274752 1.6630187105529104e-07 -0.08128056209938761 +0.7473000000000001 0.673213288021715 0.6732105553302863 1.5078257726772182e-07 -0.08128571659544855 +0.7474000000000001 0.6732228581284202 0.6732201217927691 1.352257446955718e-07 -0.08129086981867742 +0.7475 0.6732324255768658 0.6732296859158218 1.196346330577247e-07 -0.08129602176930789 +0.7476 0.6732419903672682 0.6732392477003082 1.0401250888705804e-07 -0.08130117244757357 +0.7477 0.673251552499877 0.6732488071470597 8.836264484002321e-08 -0.08130632185370812 +0.7478 0.6732611119749756 0.6732583642568734 7.26883190339811e-08 -0.08131146998794521 +0.7479000000000001 0.6732706687928807 0.6732679190305126 5.699281433596548e-08 -0.08131661685051846 +0.748 0.6732802229539422 0.6732774714687078 4.127941768440613e-08 -0.08132176244166155 +0.7481 0.6732897744585441 0.6732870215721549 2.5551419403913034e-08 -0.08132690676160811 +0.7482000000000001 0.6732993233071038 0.6732965693415165 9.812112511387028e-09 -0.0813320498105918 +0.7483000000000001 0.6733088695000725 0.6733061147774215 -5.935207973532808e-09 -0.08133719158884631 +0.7484000000000001 0.6733184130379348 0.6733156578804645 -2.1687245717154358e-08 -0.0813423320966052 +0.7485 0.6733279539212094 0.6733251986512072 -3.7440703756080884e-08 -0.08134747133410228 +0.7486 0.673337492150448 0.6733347370901769 -5.319228519559986e-08 -0.08135260930157108 +0.7487 0.673347027726237 0.6733442731978673 -6.893869390015711e-08 -0.08135774599924539 +0.7488 0.6733565606491955 0.6733538069747378 -8.46766351758621e-08 -0.08136288142735877 +0.7489000000000001 0.6733660909199767 0.6733633384212152 -1.004028164696899e-07 -0.08136801558614495 +0.749 0.6733756185392673 0.6733728675376914 -1.1611394805204067e-07 -0.08137314847583763 +0.7491 0.6733851435077877 0.6733823943245253 -1.3180674370699696e-07 -0.08137828009667039 +0.7492000000000001 0.6733946658262913 0.6733919187820416 -1.4747792142361105e-07 -0.08138341044887692 +0.7493000000000001 0.673404185495566 0.6734014409105324 -1.6312420407504913e-07 -0.08138853953269101 +0.7494000000000001 0.6734137025164323 0.6734109607102552 -1.787423201116134e-07 -0.08139366734834622 +0.7495 0.6734232168897443 0.6734204781814341 -1.9432900424942723e-07 -0.08139879389607624 +0.7496 0.6734327286163894 0.6734299933242606 -2.0988099813656902e-07 -0.08140391917611475 +0.7497 0.6734422376972884 0.6734395061388923 -2.253950510573699e-07 -0.08140904318869552 +0.7498 0.673451744133395 0.6734490166254533 -2.408679205812003e-07 -0.0814141659340521 +0.7499000000000001 0.6734612479256963 0.6734585247840352 -2.562963732875845e-07 -0.08141928741241827 +0.75 0.6734707490752119 0.6734680306146961 -2.7167718539763963e-07 -0.08142440762402768 +0.7501 0.6734802475829944 0.6734775341174608 -2.870071434887822e-07 -0.08142952656911402 +0.7502000000000001 0.6734897434501296 0.673487035292322 -3.022830450810643e-07 -0.08143464424791098 +0.7503000000000001 0.6734992366777354 0.6734965341392393 -3.175016994663715e-07 -0.08143976066065226 +0.7504000000000001 0.6735087272669624 0.6735060306581393 -3.3265992820802337e-07 -0.0814448758075715 +0.7505 0.6735182152189937 0.673515524848917 -3.4775456590058207e-07 -0.08144998968890249 +0.7506 0.6735277005350441 0.6735250167114342 -3.627824608359864e-07 -0.08145510230487883 +0.7507 0.6735371832163612 0.6735345062455207 -3.777404755725411e-07 -0.0814602136557342 +0.7508 0.6735466632642242 0.6735439934509749 -3.926254877259505e-07 -0.08146532374170244 +0.7509000000000001 0.673556140679944 0.6735534783275623 -4.0743439048279706e-07 -0.08147043256301706 +0.751 0.6735656154648634 0.6735629608750175 -4.221640933707582e-07 -0.08147554011991193 +0.7511 0.6735750876203562 0.6735724410930429 -4.368115228622904e-07 -0.0814806464126206 +0.7512000000000001 0.6735845571478281 0.6735819189813099 -4.5137362295055716e-07 -0.08148575144137686 +0.7513000000000001 0.6735940240487154 0.6735913945394586 -4.6584735589189075e-07 -0.08149085520641436 +0.7514000000000001 0.6736034883244855 0.6736008677670982 -4.802297027609037e-07 -0.08149595770796686 +0.7515 0.6736129499766363 0.6736103386638067 -4.945176641235616e-07 -0.08150105894626801 +0.7516 0.6736224090066965 0.673619807229132 -5.087082606825e-07 -0.08150615892155152 +0.7517 0.6736318654162248 0.6736292734625915 -5.227985338251973e-07 -0.08151125763405115 +0.7518 0.67364131920681 0.673638737363672 -5.367855463039861e-07 -0.08151635508400051 +0.7519000000000001 0.6736507703800712 0.6736481989318308 -5.506663828813707e-07 -0.0815214512716334 +0.752 0.6736602189376562 0.6736576581664953 -5.64438150829627e-07 -0.08152654619718341 +0.7521 0.6736696648812429 0.6736671150670636 -5.780979806524478e-07 -0.08153163986088437 +0.7522000000000001 0.6736791082125386 0.6736765696329041 -5.916430265290318e-07 -0.08153673226296994 +0.7523000000000001 0.6736885489332786 0.6736860218633567 -6.050704671189955e-07 -0.0815418234036738 +0.7524000000000001 0.6736979870452273 0.6736954717577323 -6.183775059925845e-07 -0.0815469132832297 +0.7525 0.6737074225501778 0.6737049193153133 -6.315613723245628e-07 -0.08155200190187135 +0.7526 0.6737168554499506 0.6737143645353538 -6.4461932135218e-07 -0.08155708925983242 +0.7527 0.6737262857463947 0.6737238074170802 -6.575486349996718e-07 -0.08156217535734668 +0.7528 0.6737357134413863 0.6737332479596909 -6.703466224888821e-07 -0.08156726019464779 +0.7529000000000001 0.6737451385368289 0.6737426861623572 -6.830106208666198e-07 -0.08157234377196948 +0.753 0.6737545610346531 0.6737521220242231 -6.955379954903806e-07 -0.08157742608954544 +0.7531 0.6737639809368163 0.6737615555444061 -7.07926140722237e-07 -0.08158250714760942 +0.7532000000000001 0.673773398245302 0.6737709867219965 -7.201724804839493e-07 -0.0815875869463951 +0.7533000000000001 0.67378281296212 0.6737804155560593 -7.322744684928884e-07 -0.08159266548613622 +0.7534000000000001 0.673792225089306 0.6737898420456326 -7.442295891640915e-07 -0.08159774276706647 +0.7535 0.6738016346289211 0.67379926618973 -7.560353579155743e-07 -0.0816028187894196 +0.7536 0.6738110415830509 0.6738086879873391 -7.676893218067082e-07 -0.08160789355342932 +0.7537 0.6738204459538069 0.673818107437423 -7.791890599961881e-07 -0.0816129670593293 +0.7538 0.6738298477433242 0.6738275245389196 -7.90532184199999e-07 -0.0816180393073533 +0.7539000000000001 0.6738392469537626 0.6738369392907428 -8.017163392187721e-07 -0.081623110297735 +0.754 0.6738486435873057 0.6738463516917832 -8.127392035067738e-07 -0.08162818003070813 +0.7541 0.6738580376461598 0.6738557617409071 -8.235984895327286e-07 -0.08163324850650641 +0.7542000000000001 0.6738674291325554 0.673865169436958 -8.342919444043195e-07 -0.08163831572536356 +0.7543000000000001 0.6738768180487451 0.673874574778756 -8.448173501596212e-07 -0.08164338168751334 +0.7544000000000001 0.6738862043970036 0.6738839777650992 -8.551725243777231e-07 -0.08164844639318933 +0.7545 0.6738955881796285 0.6738933783947636 -8.653553205811848e-07 -0.08165350984262537 +0.7546 0.6739049693989384 0.6739027766665029 -8.753636286523703e-07 -0.08165857203605512 +0.7547 0.6739143480572732 0.67391217257905 -8.851953752914143e-07 -0.0816636329737123 +0.7548 0.6739237241569941 0.6739215661311171 -8.948485244741899e-07 -0.0816686926558307 +0.7549000000000001 0.6739330977004825 0.6739309573213943 -9.043210777714972e-07 -0.08167375108264396 +0.755 0.6739424686901397 0.6739403461485529 -9.136110750429527e-07 -0.08167880825438581 +0.7551 0.6739518371283874 0.6739497326112438 -9.227165945618898e-07 -0.08168386417128996 +0.7552000000000001 0.6739612030176657 0.6739591167080985 -9.316357534316921e-07 -0.08168891883359014 +0.7553000000000001 0.6739705663604345 0.6739684984377293 -9.403667080992717e-07 -0.08169397224152003 +0.7554000000000001 0.6739799271591721 0.6739778777987304 -9.489076546742581e-07 -0.0816990243953134 +0.7555 0.6739892854163743 0.673987254789677 -9.572568294702322e-07 -0.08170407529520392 +0.7556 0.673998641134555 0.6739966294091274 -9.654125089630927e-07 -0.08170912494142535 +0.7557 0.6740079943162455 0.6740060016556216 -9.733730106376015e-07 -0.08171417333421137 +0.7558 0.6740173449639937 0.6740153715276833 -9.8113669294575e-07 -0.0817192204737957 +0.7559000000000001 0.6740266930803643 0.6740247390238192 -9.887019560284038e-07 -0.08172426636041208 +0.756 0.6740360386679376 0.6740341041425201 -9.960672414655036e-07 -0.08172931099429416 +0.7561 0.6740453817293098 0.6740434668822608 -1.0032310333030203e-06 -0.0817343543756757 +0.7562000000000001 0.674054722267092 0.6740528272415016 -1.010191857830911e-06 -0.08173939650479041 +0.7563000000000001 0.6740640602839099 0.6740621852186869 -1.016948284165986e-06 -0.08174443738187195 +0.7564000000000001 0.6740733957824041 0.6740715408122477 -1.0234989244461978e-06 -0.08174947700715413 +0.7565 0.6740827287652287 0.6740808940206003 -1.0298424341914636e-06 -0.08175451538087058 +0.7566 0.6740920592350508 0.6740902448421481 -1.0359775124701986e-06 -0.08175955250325506 +0.7567 0.6741013871945509 0.6740995932752808 -1.0419029021768722e-06 -0.08176458837454122 +0.7568 0.6741107126464216 0.6741089393183761 -1.0476173905038522e-06 -0.0817696229949628 +0.7569000000000001 0.6741200355933681 0.6741182829697994 -1.0531198088303828e-06 -0.0817746563647535 +0.757 0.674129356038107 0.6741276242279043 -1.0584090333332075e-06 -0.08177968848414707 +0.7571 0.6741386739833655 0.6741369630910328 -1.0634839849033018e-06 -0.08178471935337717 +0.7572000000000001 0.6741479894318818 0.674146299557517 -1.0683436297287408e-06 -0.08178974897267753 +0.7573000000000001 0.6741573023864046 0.6741556336256782 -1.0729869790448987e-06 -0.08179477734228185 +0.7574000000000001 0.6741666128496917 0.674164965293828 -1.0774130897728273e-06 -0.08179980446242385 +0.7575 0.6741759208245107 0.674174294560268 -1.081621064380478e-06 -0.0818048303333372 +0.7576 0.6741852263136376 0.6741836214232919 -1.0856100512712796e-06 -0.08180985495525561 +0.7577 0.6741945293198572 0.6741929458811842 -1.0893792449506723e-06 -0.0818148783284128 +0.7578 0.6742038298459614 0.6742022679322218 -1.0929278861093739e-06 -0.08181990045304247 +0.7579000000000001 0.6742131278947503 0.6742115875746744 -1.0962552618731802e-06 -0.08182492132937831 +0.758 0.6742224234690302 0.6742209048068037 -1.0993607058029653e-06 -0.08182994095765402 +0.7581 0.6742317165716141 0.6742302196268659 -1.10224359808897e-06 -0.08183495933810328 +0.7582000000000001 0.6742410072053211 0.6742395320331107 -1.1049033657450913e-06 -0.08183997647095984 +0.7583000000000001 0.6742502953729756 0.6742488420237822 -1.1073394827754157e-06 -0.08184499235645733 +0.7584000000000001 0.6742595810774067 0.6742581495971196 -1.1095514699521747e-06 -0.08185000699482947 +0.7585 0.6742688643214486 0.6742674547513574 -1.1115388953986116e-06 -0.08185502038630998 +0.7586 0.6742781451079389 0.6742767574847259 -1.1133013742836706e-06 -0.08186003253113254 +0.7587 0.6742874234397195 0.6742860577954517 -1.1148385690717966e-06 -0.08186504342953085 +0.7588 0.6742966993196342 0.6742953556817585 -1.1161501894951797e-06 -0.08187005308173857 +0.7589000000000001 0.6743059727505303 0.6743046511418671 -1.1172359928313114e-06 -0.0818750614879894 +0.759 0.6743152437352569 0.6743139441739963 -1.1180957836531835e-06 -0.08188006864851705 +0.7591 0.6743245122766646 0.674323234776363 -1.1187294140513337e-06 -0.08188507456355519 +0.7592000000000001 0.674333778377605 0.6743325229471829 -1.119136783578334e-06 -0.08189007923333748 +0.7593000000000001 0.6743430420409307 0.6743418086846714 -1.1193178392487901e-06 -0.08189508265809765 +0.7594000000000001 0.674352303269494 0.674351091987043 -1.1192725759001654e-06 -0.08190008483806938 +0.7595 0.674361562066147 0.6743603728525132 -1.1190010354433788e-06 -0.08190508577348632 +0.7596 0.674370818433741 0.6743696512792972 -1.1185033076954731e-06 -0.08191008546458217 +0.7597 0.6743800723751259 0.6743789272656124 -1.1177795296579696e-06 -0.0819150839115906 +0.7598 0.67438932389315 0.6743882008096777 -1.1168298858221792e-06 -0.08192008111474533 +0.7599000000000001 0.6743985729906585 0.6743974719097138 -1.115654608307981e-06 -0.08192507707427997 +0.76 0.674407819670495 0.6744067405639442 -1.1142539764197323e-06 -0.08193007179042822 +0.7601 0.6744170639354988 0.674416006770596 -1.112628316785047e-06 -0.08193506526342374 +0.7602000000000001 0.674426305788506 0.6744252705278992 -1.1107780031605063e-06 -0.08194005749350022 +0.7603000000000001 0.6744355452323484 0.674434531834089 -1.10870345648717e-06 -0.08194504848089135 +0.7604000000000001 0.6744447822698527 0.6744437906874039 -1.1064051448073098e-06 -0.08195003822583075 +0.7605 0.6744540169038409 0.6744530470860887 -1.103883583125631e-06 -0.08195502672855214 +0.7606 0.6744632491371289 0.6744623010283929 -1.101139333103962e-06 -0.08196001398928911 +0.7607 0.6744724789725263 0.6744715525125724 -1.0981730032555426e-06 -0.08196500000827538 +0.7608 0.6744817064128368 0.6744808015368903 -1.0949852486119571e-06 -0.08196998478574463 +0.7609000000000001 0.6744909314608563 0.6744900480996152 -1.0915767706676238e-06 -0.08197496832193045 +0.761 0.6745001541193729 0.6744992921990243 -1.0879483171855053e-06 -0.08197995061706649 +0.7611 0.6745093743911676 0.6745085338334025 -1.0841006819750643e-06 -0.08198493167138649 +0.7612000000000001 0.6745185922790122 0.6745177730010433 -1.0800347048922632e-06 -0.08198991148512408 +0.7613000000000001 0.6745278077856693 0.6745270097002487 -1.0757512715342532e-06 -0.08199489005851283 +0.7614000000000001 0.6745370209138928 0.6745362439293306 -1.0712513130173296e-06 -0.08199986739178658 +0.7615 0.6745462316664252 0.6745454756866103 -1.0665358058659091e-06 -0.08200484348517878 +0.7616 0.6745554400460001 0.6745547049704192 -1.061605771845997e-06 -0.08200981833892315 +0.7617 0.6745646460553394 0.6745639317791001 -1.0564622776321198e-06 -0.08201479195325333 +0.7618 0.6745738496971542 0.6745731561110067 -1.0511064344742582e-06 -0.08201976432840298 +0.7619000000000001 0.6745830509741432 0.674582377964504 -1.04553939830887e-06 -0.0820247354646057 +0.762 0.6745922498889931 0.6745915973379701 -1.0397623692315339e-06 -0.08202970536209518 +0.7621 0.6746014464443782 0.6746008142297946 -1.033776591219393e-06 -0.082034674021105 +0.7622000000000001 0.6746106406429595 0.6746100286383805 -1.0275833521589117e-06 -0.08203964144186882 +0.7623000000000001 0.6746198324873842 0.674619240562145 -1.0211839831519853e-06 -0.08204460762462032 +0.7624000000000001 0.6746290219802856 0.6746284499995181 -1.0145798585992072e-06 -0.08204957256959308 +0.7625 0.6746382091242823 0.6746376569489445 -1.0077723958112905e-06 -0.08205453627702068 +0.7626000000000001 0.6746473939219786 0.6746468614088845 -1.0007630545927348e-06 -0.08205949874713687 +0.7627 0.6746565763759627 0.6746560633778125 -9.93553336908759e-07 -0.08206445998017521 +0.7628 0.6746657564888072 0.6746652628542188 -9.861447867465234e-07 -0.08206941997636924 +0.7629000000000001 0.6746749342630691 0.6746744598366105 -9.785389896987962e-07 -0.08207437873595264 +0.763 0.6746841097012879 0.6746836543235102 -9.707375727141532e-07 -0.082079336259159 +0.7631 0.6746932828059871 0.6746928463134587 -9.627422034308442e-07 -0.08208429254622202 +0.7632000000000001 0.6747024535796715 0.6747020358050131 -9.545545901767927e-07 -0.08208924759737526 +0.7633000000000001 0.6747116220248288 0.6747112227967487 -9.461764815255069e-07 -0.08209420141285231 +0.7634000000000001 0.6747207881439283 0.6747204072872586 -9.376096657964794e-07 -0.08209915399288682 +0.7635 0.6747299519394203 0.6747295892751549 -9.288559708747757e-07 -0.08210410533771234 +0.7636000000000001 0.6747391134137366 0.6747387687590685 -9.199172635865338e-07 -0.08210905544756252 +0.7637 0.674748272569289 0.6747479457376497 -9.107954495046755e-07 -0.08211400432267088 +0.7638 0.6747574294084695 0.6747571202095684 -9.014924724354278e-07 -0.08211895196327111 +0.7639000000000001 0.6747665839336499 0.6747662921735149 -8.920103140297453e-07 -0.08212389836959673 +0.764 0.6747757361471812 0.6747754616282005 -8.82350993366976e-07 -0.08212884354188141 +0.7641 0.6747848860513936 0.674784628572356 -8.725165665662837e-07 -0.08213378748035866 +0.7642 0.6747940336485956 0.6747937930047351 -8.625091262731699e-07 -0.08213873018526208 +0.7643000000000001 0.6748031789410742 0.674802954924112 -8.523308012708952e-07 -0.08214367165682528 +0.7644000000000001 0.674812321931094 0.6748121143292838 -8.419837560363908e-07 -0.08214861189528182 +0.7645 0.674821462620897 0.6748212712190695 -8.314701902267796e-07 -0.08215355090086529 +0.7646000000000001 0.6748306010127029 0.6748304255923111 -8.207923382491655e-07 -0.0821584886738093 +0.7647 0.6748397371087071 0.6748395774478733 -8.099524687887882e-07 -0.08216342521434732 +0.7648 0.6748488709110824 0.6748487267846449 -7.989528843649341e-07 -0.08216836052271298 +0.7649000000000001 0.6748580024219772 0.6748578736015383 -7.877959207897023e-07 -0.08217329459913986 +0.765 0.6748671316435159 0.6748670178974896 -7.764839466406492e-07 -0.08217822744386151 +0.7651 0.6748762585777979 0.6748761596714596 -7.650193629138435e-07 -0.08218315905711146 +0.7652 0.6748853832268984 0.6748852989224344 -7.534046023438545e-07 -0.08218808943912333 +0.7653000000000001 0.6748945055928663 0.6748944356494246 -7.416421288763964e-07 -0.08219301859013062 +0.7654000000000001 0.674903625677726 0.6749035698514667 -7.29734437335261e-07 -0.08219794651036688 +0.7655 0.6749127434834754 0.6749127015276226 -7.176840526867956e-07 -0.08220287320006574 +0.7656000000000001 0.6749218590120862 0.6749218306769806 -7.054935297623466e-07 -0.08220779865946064 +0.7657 0.6749309722655039 0.6749309572986549 -6.931654523839592e-07 -0.08221272288878519 +0.7658 0.674940083245647 0.6749400813917869 -6.807024331700884e-07 -0.08221764588827289 +0.7659000000000001 0.6749491919544071 0.6749492029555444 -6.681071126751759e-07 -0.08222256765815729 +0.766 0.6749582983936482 0.6749583219891229 -6.553821589871944e-07 -0.0822274881986719 +0.7661 0.6749674025652068 0.6749674384917451 -6.425302671586586e-07 -0.08223240751005026 +0.7662 0.6749765044708917 0.6749765524626619 -6.295541586098796e-07 -0.0822373255925259 +0.7663000000000001 0.6749856041124835 0.6749856639011518 -6.16456580587732e-07 -0.08224224244633238 +0.7664000000000001 0.6749947014917339 0.6749947728065218 -6.032403055411528e-07 -0.08224715807170319 +0.7665 0.6750037966103665 0.6750038791781074 -5.899081305243969e-07 -0.08225207246887184 +0.7666000000000001 0.6750128894700754 0.6750129830152732 -5.7646287673907e-07 -0.08225698563807186 +0.7667 0.675021980072526 0.6750220843174125 -5.629073887708502e-07 -0.08226189757953677 +0.7668 0.6750310684193541 0.6750311830839479 -5.492445339788654e-07 -0.08226680829350003 +0.7669000000000001 0.6750401545121659 0.6750402793143319 -5.354772020654819e-07 -0.08227171778019517 +0.767 0.6750492383525377 0.6750493730080459 -5.216083043407815e-07 -0.08227662603985568 +0.7671 0.6750583199420155 0.6750584641646025 -5.076407731535726e-07 -0.08228153307271506 +0.7672 0.6750673992821152 0.6750675527835435 -4.935775611836224e-07 -0.08228643887900679 +0.7673000000000001 0.6750764763743227 0.6750766388644414 -4.794216409212404e-07 -0.08229134345896438 +0.7674000000000001 0.675085551220092 0.6750857224068995 -4.651760040635944e-07 -0.0822962468128213 +0.7675 0.6750946238208473 0.6750948034105515 -4.508436607514321e-07 -0.08230114894081104 +0.7676000000000001 0.6751036941779812 0.6751038818750624 -4.3642763904172543e-07 -0.08230604984316708 +0.7677 0.6751127622928554 0.6751129578001279 -4.2193098420684194e-07 -0.08231094952012291 +0.7678 0.6751218281667998 0.6751220311854755 -4.0735675815167793e-07 -0.08231584797191195 +0.7679000000000001 0.6751308918011129 0.6751311020308638 -3.927080387128301e-07 -0.08232074519876774 +0.768 0.6751399531970612 0.6751401703360832 -3.779879190479729e-07 -0.08232564120092367 +0.7681 0.67514901235588 0.6751492361009559 -3.63199506948908e-07 -0.08233053597861326 +0.7682 0.6751580692787716 0.6751582993253359 -3.483459242240028e-07 -0.08233542953206993 +0.7683000000000001 0.6751671239669066 0.6751673600091093 -3.334303059904231e-07 -0.08234032186152712 +0.7684000000000001 0.6751761764214232 0.6751764181521946 -3.184558000843274e-07 -0.08234521296721832 +0.7685 0.6751852266434273 0.6751854737545426 -3.03425566311466e-07 -0.08235010284937694 +0.7686000000000001 0.6751942746339921 0.6751945268161361 -2.8834277583655865e-07 -0.08235499150823646 +0.7687 0.6752033203941582 0.6752035773369911 -2.7321061053797724e-07 -0.08235987894403025 +0.7688 0.6752123639249331 0.6752126253171555 -2.580322622652842e-07 -0.0823647651569918 +0.7689000000000001 0.675221405227292 0.6752216707567112 -2.4281093222167094e-07 -0.08236965014735456 +0.769 0.6752304443021766 0.6752307136557716 -2.275498302284351e-07 -0.0823745339153519 +0.7691 0.6752394811504956 0.6752397540144834 -2.122521741421135e-07 -0.08237941646121723 +0.7692 0.6752485157731248 0.675248791833027 -1.969211890912037e-07 -0.08238429778518401 +0.7693000000000001 0.675257548170907 0.6752578271116151 -1.8156010685513313e-07 -0.08238917788748563 +0.7694000000000001 0.6752665783446511 0.675266859850494 -1.6617216513567512e-07 -0.08239405676835554 +0.7695 0.6752756062951331 0.6752758900499427 -1.5076060688734572e-07 -0.08239893442802708 +0.7696000000000001 0.6752846320230954 0.6752849177102743 -1.353286796790254e-07 -0.0824038108667337 +0.7697 0.6752936555292475 0.6752939428318343 -1.1987963493935438e-07 -0.08240868608470878 +0.7698 0.6753026768142647 0.6753029654150022 -1.0441672732876273e-07 -0.0824135600821857 +0.7699000000000001 0.6753116958787893 0.6753119854601903 -8.894321400221283e-08 -0.08241843285939787 +0.77 0.6753207127234301 0.6753210029678448 -7.34623539829643e-08 -0.08242330441657868 +0.7701 0.6753297273487622 0.6753300179384447 -5.7977407422714344e-08 -0.08242817475396148 +0.7702 0.675338739755327 0.6753390303725031 -4.2491634945221804e-08 -0.08243304387177963 +0.7703000000000001 0.6753477499436329 0.6753480402705658 -2.700829694905673e-08 -0.08243791177026655 +0.7704000000000001 0.6753567579141546 0.6753570476332125 -1.153065292292671e-08 -0.08244277844965558 +0.7705 0.6753657636673331 0.6753660524610557 3.93803924105679e-09 -0.08244764391018006 +0.7706000000000001 0.675374767203576 0.6753750547547425 1.9394523934762598e-08 -0.08245250815207343 +0.7707 0.6753837685232578 0.6753840545149518 3.4835548515244064e-08 -0.08245737117556896 +0.7708 0.675392767626719 0.6753930517423966 5.0257863995484264e-08 -0.08246223298090005 +0.7709000000000001 0.675401764514267 0.675402046437823 6.565822572961177e-08 -0.0824670935683 +0.771 0.6754107591861761 0.6754110386020103 8.103339407990184e-08 -0.08247195293800215 +0.7711 0.6754197516426869 0.6754200282357714 9.63801351193394e-08 -0.08247681109023988 +0.7712 0.6754287418840073 0.6754290153399511 1.1169522131510012e-07 -0.0824816680252465 +0.7713000000000001 0.6754377299103114 0.6754379999154286 1.2697543216172447e-07 -0.08248652374325532 +0.7714000000000001 0.6754467157217409 0.675446981963115 1.4221755493051824e-07 -0.08249137824449969 +0.7715 0.6754556993184045 0.6754559614839547 1.5741838527844054e-07 -0.08249623152921293 +0.7716000000000001 0.6754646807003775 0.6754649384789246 1.7257472798709594e-07 -0.0825010835976283 +0.7717 0.6754736598677027 0.6754739129490347 1.8768339756988772e-07 -0.08250593444997915 +0.7718 0.6754826368203902 0.6754828848953273 2.0274121897978503e-07 -0.0825107840864988 +0.7719000000000001 0.6754916115584177 0.6754918543188769 2.1774502829280395e-07 -0.08251563250742049 +0.772 0.6755005840817305 0.6755008212207908 2.3269167334638574e-07 -0.08252047971297757 +0.7721 0.6755095543902412 0.6755097856022083 2.475780143951223e-07 -0.08252532570340335 +0.7722 0.6755185224838303 0.6755187474643005 2.624009247664816e-07 -0.08253017047893103 +0.7723000000000001 0.6755274883623466 0.6755277068082706 2.7715729154775826e-07 -0.08253501403979395 +0.7724000000000001 0.6755364520256065 0.6755366636353537 2.9184401623139067e-07 -0.08253985638622535 +0.7725 0.6755454134733954 0.6755456179468164 3.0645801539497253e-07 -0.08254469751845853 +0.7726000000000001 0.675554372705466 0.6755545697439569 3.2099622128412e-07 -0.08254953743672672 +0.7727 0.6755633297215409 0.6755635190281047 3.35455582506361e-07 -0.08255437614126322 +0.7728 0.67557228452131 0.6755724658006201 3.49833064641758e-07 -0.08255921363230126 +0.7729000000000001 0.6755812371044334 0.6755814100628948 3.6412565088822513e-07 -0.0825640499100741 +0.773 0.6755901874705397 0.675590351816351 3.78330342783173e-07 -0.08256888497481496 +0.7731 0.6755991356192266 0.6755992910624413 3.9244416061984255e-07 -0.08257371882675708 +0.7732 0.6756080815500618 0.6756082278026492 4.064641443285444e-07 -0.08257855146613371 +0.7733000000000001 0.6756170252625826 0.6756171620384879 4.203873539415648e-07 -0.08258338289317811 +0.7734000000000001 0.675625966756296 0.6756260937715008 4.3421087018991056e-07 -0.08258821310812348 +0.7735 0.6756349060306793 0.6756350230032611 4.4793179526658733e-07 -0.08259304211120302 +0.7736000000000001 0.6756438430851802 0.6756439497353712 4.615472532915055e-07 -0.08259786990264997 +0.7737 0.6756527779192167 0.6756528739694632 4.750543910053695e-07 -0.08260269648269754 +0.7738 0.6756617105321778 0.6756617957071976 4.88450378297034e-07 -0.0826075218515789 +0.7739000000000001 0.6756706409234239 0.6756707149502647 5.017324088418817e-07 -0.08261234600952727 +0.774 0.6756795690922861 0.6756796317003824 5.148977006569355e-07 -0.08261716895677586 +0.7741 0.6756884950380675 0.6756885459592974 5.279434967531138e-07 -0.08262199069355784 +0.7742 0.6756974187600429 0.6756974577287842 5.408670656070758e-07 -0.08262681122010639 +0.7743000000000001 0.6757063402574592 0.6757063670106453 5.536657018689883e-07 -0.08263163053665469 +0.7744000000000001 0.6757152595295357 0.6757152738067107 5.663367268898822e-07 -0.08263644864343586 +0.7745 0.6757241765754645 0.6757241781188376 5.788774891796189e-07 -0.08264126554068317 +0.7746000000000001 0.6757330913944104 0.6757330799489101 5.91285364962002e-07 -0.08264608122862976 +0.7747 0.6757420039855113 0.6757419792988388 6.035577589796892e-07 -0.08265089570750876 +0.7748 0.6757509143478786 0.6757508761705611 6.156921047301145e-07 -0.08265570897755327 +0.7749000000000001 0.675759822480598 0.6757597705660396 6.276858651732553e-07 -0.08266052103899647 +0.775 0.6757687283827287 0.6757686624872639 6.395365332867442e-07 -0.0826653318920715 +0.7751 0.6757776320533053 0.6757775519362479 6.51241632440569e-07 -0.08267014153701152 +0.7752 0.6757865334913361 0.6757864389150313 6.627987169799399e-07 -0.08267494997404964 +0.7753000000000001 0.6757954326958049 0.6757953234256786 6.742053728775455e-07 -0.08267975720341898 +0.7754000000000001 0.675804329665671 0.6758042054702782 6.854592180666197e-07 -0.08268456322535267 +0.7755 0.6758132243998691 0.6758130850509431 6.965579029682978e-07 -0.08268936804008378 +0.7756000000000001 0.6758221168973104 0.67582196216981 7.074991110050943e-07 -0.08269417164784547 +0.7757000000000001 0.6758310071568819 0.6758308368290393 7.182805592392816e-07 -0.08269897404887078 +0.7758 0.6758398951774482 0.6758397090308144 7.288999984839117e-07 -0.08270377524339287 +0.7759000000000001 0.6758487809578504 0.6758485787773411 7.393552141077286e-07 -0.08270857523164477 +0.776 0.6758576644969073 0.675857446070848 7.496440264515014e-07 -0.08271337401385961 +0.7761 0.6758665457934154 0.6758663109135854 7.597642911472136e-07 -0.08271817159027048 +0.7762 0.6758754248461494 0.6758751733078259 7.697138995899078e-07 -0.08272296796111038 +0.7763000000000001 0.6758843016538625 0.6758840332558624 7.794907796315753e-07 -0.08272776312661234 +0.7764000000000001 0.6758931762152871 0.6758928907600099 7.890928954978893e-07 -0.08273255708700954 +0.7765 0.6759020485291349 0.6759017458226031 7.985182488290388e-07 -0.08273734984253497 +0.7766000000000001 0.6759109185940972 0.6759105984459974 8.077648786658509e-07 -0.0827421413934217 +0.7767000000000001 0.6759197864088452 0.6759194486325677 8.16830861907758e-07 -0.08274693173990276 +0.7768 0.6759286519720309 0.6759282963847082 8.257143140066869e-07 -0.08275172088221118 +0.7769000000000001 0.675937515282287 0.6759371417048321 8.344133889670591e-07 -0.08275650882058 +0.777 0.6759463763382279 0.6759459845953717 8.429262799425352e-07 -0.08276129555524227 +0.7771 0.6759552351384486 0.6759548250587766 8.512512196939825e-07 -0.08276608108643092 +0.7772 0.6759640916815275 0.6759636630975152 8.593864807698859e-07 -0.08277086541437906 +0.7773000000000001 0.6759729459660246 0.6759724987140723 8.673303759643147e-07 -0.08277564853931962 +0.7774000000000001 0.6759817979904832 0.6759813319109501 8.750812586777457e-07 -0.08278043046148559 +0.7775 0.6759906477534305 0.6759901626906675 8.826375231807404e-07 -0.08278521118111004 +0.7776000000000001 0.6759994952533763 0.6759989910557592 8.899976049470126e-07 -0.08278999069842591 +0.7777000000000001 0.6760083404888154 0.6760078170087759 8.971599813334397e-07 -0.08279476901366621 +0.7778 0.6760171834582269 0.6760166405522828 9.041231712469955e-07 -0.08279954612706383 +0.7779 0.6760260241600752 0.676025461688861 9.108857360606848e-07 -0.08280432203885185 +0.778 0.6760348625928099 0.676034280421105 9.174462794747651e-07 -0.08280909674926316 +0.7781 0.6760436987548666 0.676043096751624 9.238034480718582e-07 -0.0828138702585307 +0.7782 0.6760525326446676 0.6760519106830403 9.299559315389949e-07 -0.08281864256688747 +0.7783000000000001 0.6760613642606215 0.6760607222179893 9.359024629451707e-07 -0.08282341367456636 +0.7784000000000001 0.6760701936011247 0.6760695313591192 9.416418187968567e-07 -0.08282818358180037 +0.7785 0.6760790206645613 0.6760783381090898 9.471728196763785e-07 -0.08283295228882241 +0.7786000000000001 0.676087845449303 0.6760871424705733 9.524943302419153e-07 -0.08283771979586539 +0.7787000000000001 0.6760966679537103 0.6760959444462529 9.576052594495454e-07 -0.08284248610316221 +0.7788 0.6761054881761331 0.6761047440388226 9.625045608308014e-07 -0.08284725121094585 +0.7789 0.6761143061149109 0.6761135412509865 9.67191232770226e-07 -0.08285201511944917 +0.779 0.6761231217683725 0.6761223360854587 9.71664318699661e-07 -0.08285677782890502 +0.7791 0.676131935134838 0.6761311285449628 9.759229070982478e-07 -0.08286153933954632 +0.7792 0.6761407462126177 0.6761399186322314 9.79966131881005e-07 -0.08286629965160597 +0.7793000000000001 0.6761495550000138 0.6761487063500053 9.837931726763838e-07 -0.0828710587653168 +0.7794000000000001 0.6761583614953204 0.6761574917010336 9.874032545487132e-07 -0.08287581668091171 +0.7795 0.6761671656968238 0.6761662746880732 9.907956487753555e-07 -0.08288057339862365 +0.7796000000000001 0.6761759676028031 0.676175055313887 9.939696724303726e-07 -0.08288532891868534 +0.7797000000000001 0.6761847672115306 0.6761838335812456 9.969246889118821e-07 -0.08289008324132975 +0.7798 0.6761935645212722 0.6761926094929251 9.99660107969813e-07 -0.08289483636678964 +0.7799 0.6762023595302883 0.6762013830517074 1.0021753855116167e-06 -0.08289958829529781 +0.78 0.6762111522368339 0.6762101542603796 1.0044700243239113e-06 -0.08290433902708715 +0.7801 0.6762199426391597 0.6762189231217335 1.0065435737116601e-06 -0.0829090885623905 +0.7802 0.6762287307355116 0.676227689638565 1.008395629636949e-06 -0.08291383690144068 +0.7803000000000001 0.6762375165241317 0.6762364538136739 1.0100258349687863e-06 -0.0829185840444705 +0.7804000000000001 0.6762463000032586 0.6762452156498631 1.0114338793720812e-06 -0.08292332999171276 +0.7805 0.676255081171128 0.6762539751499379 1.0126194994741766e-06 -0.0829280747434002 +0.7806000000000001 0.6762638600259736 0.6762627323167065 1.013582479031383e-06 -0.08293281829976566 +0.7807000000000001 0.6762726365660268 0.6762714871529787 1.0143226486514223e-06 -0.08293756066104191 +0.7808 0.6762814107895179 0.6762802396615653 1.0148398861542507e-06 -0.0829423018274617 +0.7809 0.6762901826946759 0.6762889898452782 1.0151341163500138e-06 -0.08294704179925787 +0.781 0.6762989522797294 0.6762977377069295 1.0152053111500692e-06 -0.08295178057666307 +0.7811 0.6763077195429075 0.6763064832493313 1.0150534896224972e-06 -0.08295651815991012 +0.7812 0.6763164844824394 0.676315226475295 1.0146787179088346e-06 -0.08296125454923181 +0.7813000000000001 0.6763252470965548 0.6763239673876309 1.0140811091963187e-06 -0.0829659897448608 +0.7814000000000001 0.6763340073834863 0.6763327059891477 1.0132608237178875e-06 -0.08297072374702989 +0.7815 0.6763427653414666 0.6763414422826517 1.0122180687244242e-06 -0.08297545655597174 +0.7816000000000001 0.6763515209687324 0.6763501762709474 1.010953098484757e-06 -0.08298018817191916 +0.7817000000000001 0.6763602742635226 0.6763589079568353 1.0094662141191257e-06 -0.08298491859510475 +0.7818 0.6763690252240795 0.6763676373431131 1.0077577635714263e-06 -0.08298964782576128 +0.7819 0.6763777738486493 0.676376364432574 1.0058281414426773e-06 -0.0829943758641214 +0.782 0.6763865201354828 0.6763850892280072 1.0036777892685755e-06 -0.08299910271041784 +0.7821 0.6763952640828358 0.6763938117321964 1.0013071947978514e-06 -0.08300382836488329 +0.7822 0.6764040056889687 0.6764025319479204 9.987168924363576e-07 -0.0830085528277504 +0.7823000000000001 0.6764127449521483 0.6764112498779518 9.959074628862474e-07 -0.08301327609925188 +0.7824000000000001 0.6764214818706472 0.6764199655250565 9.928795332292406e-07 -0.08301799817962029 +0.7825 0.6764302164427454 0.676428678891994 9.89633776399268e-07 -0.08302271906908835 +0.7826000000000001 0.6764389486667296 0.6764373899815163 9.861709113212491e-07 -0.08302743876788872 +0.7827000000000001 0.6764476785408944 0.6764460987963674 9.824917026890478e-07 -0.08303215727625403 +0.7828 0.6764564060635425 0.6764548053392834 9.785969608822054e-07 -0.08303687459441692 +0.7829 0.6764651312329852 0.6764635096129914 9.744875414940957e-07 -0.08304159072260997 +0.783 0.676473854047543 0.676472211620209 9.701643456927478e-07 -0.08304630566106583 +0.7831 0.6764825745055456 0.6764809113636446 9.656283194436899e-07 -0.08305101941001707 +0.7832 0.6764912926053332 0.6764896088459962 9.60880453648727e-07 -0.08305573196969629 +0.7833000000000001 0.6765000083452564 0.6764983040699515 9.559217838683853e-07 -0.08306044334033615 +0.7834000000000001 0.6765087217236762 0.6765069970381865 9.507533898778231e-07 -0.08306515352216914 +0.7835 0.6765174327389656 0.6765156877533662 9.453763958611194e-07 -0.0830698625154279 +0.7836000000000001 0.6765261413895094 0.6765243762181439 9.397919699116741e-07 -0.083074570320345 +0.7837000000000001 0.6765348476737041 0.6765330624351598 9.340013236713851e-07 -0.08307927693715299 +0.7838 0.6765435515899597 0.6765417464070413 9.280057123028929e-07 -0.08308398236608439 +0.7839 0.676552253136699 0.676550428136403 9.218064339899801e-07 -0.08308868660737179 +0.784 0.6765609523123584 0.6765591076258457 9.154048300208384e-07 -0.08309338966124775 +0.7841 0.6765696491153883 0.6765677848779552 9.088022839554011e-07 -0.08309809152794473 +0.7842 0.6765783435442541 0.6765764598953035 9.020002219861656e-07 -0.08310279220769531 +0.7843000000000001 0.6765870355974355 0.6765851326804474 8.950001120500151e-07 -0.083107491700732 +0.7844000000000001 0.6765957252734276 0.676593803235928 8.878034638282184e-07 -0.08311219000728728 +0.7845 0.6766044125707419 0.6766024715642704 8.80411828302341e-07 -0.08311688712759364 +0.7846000000000001 0.6766130974879054 0.676611137667984 8.728267976154669e-07 -0.08312158306188362 +0.7847000000000001 0.6766217800234622 0.6766198015495604 8.650500042950426e-07 -0.08312627781038966 +0.7848 0.6766304601759731 0.676628463211475 8.570831213500218e-07 -0.08313097137334423 +0.7849 0.6766391379440166 0.6766371226561851 8.489278619655538e-07 -0.08313566375097982 +0.785 0.676647813326189 0.6766457798861303 8.405859785454162e-07 -0.08314035494352888 +0.7851 0.6766564863211048 0.6766544349037313 8.320592628785484e-07 -0.08314504495122386 +0.7852 0.6766651569273976 0.6766630877113906 8.233495457643514e-07 -0.08314973377429724 +0.7853000000000001 0.6766738251437192 0.6766717383114913 8.144586961383871e-07 -0.08315442141298142 +0.7854000000000001 0.6766824909687417 0.6766803867063969 8.053886211140115e-07 -0.08315910786750882 +0.7855 0.6766911544011565 0.6766890328984505 7.96141265607675e-07 -0.0831637931381119 +0.7856000000000001 0.6766998154396755 0.6766976768899755 7.867186114229874e-07 -0.08316847722502306 +0.7857000000000001 0.6767084740830311 0.6767063186832745 7.771226775005191e-07 -0.08317316012847467 +0.7858 0.6767171303299766 0.6767149582806282 7.673555189324777e-07 -0.08317784184869911 +0.7859 0.6767257841792871 0.6767235956842969 7.574192269349522e-07 -0.08318252238592883 +0.786 0.6767344356297589 0.6767322308965183 7.473159279874908e-07 -0.08318720174039619 +0.7861 0.6767430846802104 0.6767408639195083 7.370477837914668e-07 -0.08319187991233354 +0.7862 0.6767517313294826 0.6767494947554595 7.266169905761899e-07 -0.08319655690197318 +0.7863000000000001 0.6767603755764396 0.676758123406543 7.160257785715496e-07 -0.08320123270954759 +0.7864000000000001 0.6767690174199684 0.6767667498749051 7.052764117582155e-07 -0.08320590733528904 +0.7865 0.6767776568589791 0.6767753741626693 6.943711872292591e-07 -0.08321058077942983 +0.7866000000000001 0.6767862938924061 0.6767839962719353 6.833124347044306e-07 -0.0832152530422024 +0.7867000000000001 0.6767949285192078 0.6767926162047779 6.721025161693372e-07 -0.08321992412383902 +0.7868 0.6768035607383671 0.6768012339632477 6.607438251537978e-07 -0.08322459402457197 +0.7869 0.6768121905488915 0.6768098495493701 6.492387863710203e-07 -0.08322926274463355 +0.787 0.6768208179498141 0.6768184629651455 6.375898551069792e-07 -0.08323393028425607 +0.7871 0.6768294429401929 0.6768270742125492 6.257995169151043e-07 -0.08323859664367184 +0.7872 0.6768380655191115 0.6768356832935295 6.138702868113688e-07 -0.08324326182311309 +0.7873000000000001 0.6768466856856807 0.6768442902100095 6.018047088995893e-07 -0.08324792582281217 +0.7874000000000001 0.6768553034390363 0.6768528949638852 5.896053558163139e-07 -0.08325258864300127 +0.7875 0.6768639187783416 0.6768614975570264 5.772748280924445e-07 -0.08325725028391268 +0.7876000000000001 0.6768725317027859 0.6768700979912755 5.648157536675136e-07 -0.08326191074577863 +0.7877000000000001 0.6768811422115866 0.6768786962684477 5.522307873623289e-07 -0.08326657002883131 +0.7878000000000001 0.6768897503039879 0.6768872923903305 5.395226102544726e-07 -0.083271228133303 +0.7879 0.6768983559792618 0.6768958863586839 5.26693929178701e-07 -0.08327588505942585 +0.788 0.6769069592367091 0.6769044781752396 5.137474761024441e-07 -0.08328054080743216 +0.7881 0.6769155600756578 0.6769130678417005 5.006860074735497e-07 -0.08328519537755408 +0.7882 0.6769241584954645 0.6769216553597415 4.875123037623164e-07 -0.08328984877002378 +0.7883000000000001 0.6769327544955153 0.6769302407310083 4.742291688369926e-07 -0.08329450098507346 +0.7884000000000001 0.6769413480752242 0.676938823957118 4.6083942931152144e-07 -0.0832991520229353 +0.7885 0.6769499392340355 0.676947405039658 4.473459340598174e-07 -0.08330380188384147 +0.7886 0.6769585279714221 0.676955983980186 4.337515534524883e-07 -0.08330845056802415 +0.7887000000000001 0.6769671142868868 0.67696456078023 4.2005917877396826e-07 -0.08331309807571544 +0.7888000000000001 0.6769756981799621 0.6769731354412883 4.0627172182006177e-07 -0.08331774440714744 +0.7889 0.6769842796502108 0.6769817079648293 3.9239211399588747e-07 -0.0833223895625524 +0.789 0.6769928586972257 0.6769902783522899 3.784233059203612e-07 -0.08332703354216235 +0.7891 0.6770014353206301 0.6769988466050774 3.6436826659352883e-07 -0.08333167634620942 +0.7892 0.6770100095200781 0.6770074127245682 3.502299829316602e-07 -0.08333631797492569 +0.7893000000000001 0.6770185812952543 0.6770159767121076 3.360114591011154e-07 -0.08334095842854329 +0.7894000000000001 0.6770271506458744 0.6770245385690099 3.217157157620054e-07 -0.08334559770729429 +0.7895 0.6770357175716853 0.6770330982965579 3.073457895894083e-07 -0.08335023581141075 +0.7896 0.6770442820724651 0.6770416558960033 2.929047325517242e-07 -0.08335487274112473 +0.7897000000000001 0.6770528441480238 0.6770502113685661 2.783956112584196e-07 -0.08335950849666834 +0.7898000000000001 0.6770614037982021 0.6770587647154346 2.6382150628001533e-07 -0.08336414307827356 +0.7899 0.6770699610228734 0.6770673159377649 2.49185511613792e-07 -0.08336877648617247 +0.79 0.677078515821942 0.6770758650366814 2.344907338650004e-07 -0.08337340872059706 +0.7901 0.6770870681953451 0.6770844120132766 2.1974029174726128e-07 -0.0833780397817794 +0.7902 0.6770956181430516 0.6770929568686105 2.0493731528459236e-07 -0.08338266966995149 +0.7903000000000001 0.6771041656650624 0.6771014996037107 1.9008494524935804e-07 -0.08338729838534527 +0.7904000000000001 0.6771127107614111 0.6771100402195722 1.7518633242674664e-07 -0.0833919259281928 +0.7905 0.6771212534321636 0.6771185787171581 1.6024463694863655e-07 -0.08339655229872604 +0.7906 0.6771297936774181 0.677127115097398 1.4526302772807642e-07 -0.08340117749717697 +0.7907000000000001 0.6771383314973058 0.6771356493611892 1.3024468163355674e-07 -0.08340580152377754 +0.7908000000000001 0.6771468668919904 0.6771441815093961 1.1519278294430668e-07 -0.08341042437875971 +0.7909 0.6771553998616685 0.6771527115428503 1.0011052258007691e-07 -0.0834150460623554 +0.791 0.6771639304065691 0.6771612394623505 8.500109748357798e-08 -0.0834196665747966 +0.7911 0.6771724585269543 0.6771697652686622 6.986770991618263e-08 -0.0834242859163152 +0.7912 0.6771809842231192 0.6771782889625182 5.471356681260864e-08 -0.08342890408714314 +0.7913000000000001 0.677189507495392 0.6771868105446176 3.95418790471308e-08 -0.08343352108751226 +0.7914000000000001 0.6771980283441335 0.6771953300156269 2.4355860798672135e-08 -0.08343813691765453 +0.7915 0.6772065467697379 0.6772038473761792 9.158728851710318e-09 -0.08344275157780184 +0.7916 0.6772150627726322 0.6772123626268745 -6.046298081999191e-09 -0.08344736506818601 +0.7917000000000001 0.6772235763532768 0.6772208757682795 -2.1256000054710456e-08 -0.08345197738903898 +0.7918000000000001 0.6772320875121646 0.6772293868009279 -3.646715654058094e-08 -0.08345658854059254 +0.7919 0.6772405962498219 0.67723789572532 -5.167654714587815e-08 -0.08346119852307858 +0.792 0.6772491025668084 0.6772464025419228 -6.688095227289081e-08 -0.08346580733672891 +0.7921 0.6772576064637164 0.6772549072511702 -8.207715380872255e-08 -0.08347041498177536 +0.7922 0.677266107941171 0.6772634098534636 -9.72619358056287e-08 -0.08347502145844979 +0.7923000000000001 0.6772746069998312 0.6772719103491702 -1.1243208515761272e-07 -0.083479626766984 +0.7924000000000001 0.6772831036403882 0.6772804087386248 -1.275843922940445e-07 -0.08348423090760979 +0.7925 0.6772915978635664 0.6772889050221288 -1.427156518414574e-07 -0.08348883388055894 +0.7926 0.6773000896701231 0.6772973991999506 -1.5782266330963135e-07 -0.08349343568606322 +0.7927000000000001 0.6773085790608485 0.6773058912723258 -1.7290223178548225e-07 -0.08349803632435443 +0.7928000000000001 0.677317066036565 0.6773143812394571 -1.8795116856623606e-07 -0.08350263579566433 +0.7929 0.6773255505981286 0.6773228691015141 -2.029662918776043e-07 -0.08350723410022465 +0.793 0.6773340327464272 0.677331354858634 -2.1794442754338728e-07 -0.08351183123826712 +0.7931 0.6773425124823815 0.677339838510921 -2.3288240962732187e-07 -0.0835164272100235 +0.7932 0.677350989806945 0.6773483200584475 -2.4777708112003194e-07 -0.08352102201572553 +0.7933000000000001 0.6773594647211026 0.6773567995012524 -2.626252946155705e-07 -0.08352561565560492 +0.7934000000000001 0.6773679372258725 0.6773652768393423 -2.774239129602063e-07 -0.08353020812989331 +0.7935 0.6773764073223045 0.6773737520726925 -2.921698099359049e-07 -0.08353479943882246 +0.7936 0.6773848750114801 0.6773822252012449 -3.0685987090911526e-07 -0.08353938958262397 +0.7937000000000001 0.6773933402945136 0.6773906962249105 -3.21490993493434e-07 -0.08354397856152962 +0.7938000000000001 0.6774018031725502 0.6773991651435675 -3.3606008816716715e-07 -0.08354856637577096 +0.7939 0.6774102636467673 0.6774076319570632 -3.5056407902966935e-07 -0.08355315302557975 +0.794 0.6774187217183733 0.6774160966652123 -3.649999043148222e-07 -0.08355773851118754 +0.7941 0.6774271773886086 0.6774245592677992 -3.793645171473736e-07 -0.08356232283282607 +0.7942 0.6774356306587438 0.6774330197645758 -3.936548861327438e-07 -0.08356690599072686 +0.7943000000000001 0.6774440815300813 0.6774414781552637 -4.0786799603703683e-07 -0.08357148798512154 +0.7944000000000001 0.6774525300039542 0.6774499344395533 -4.2200084834909113e-07 -0.08357606881624174 +0.7945 0.6774609760817258 0.6774583886171037 -4.3605046203681885e-07 -0.08358064848431901 +0.7946 0.6774694197647906 0.6774668406875446 -4.500138740329285e-07 -0.08358522698958498 +0.7947000000000001 0.677477861054573 0.677475290650474 -4.6388813997738643e-07 -0.08358980433227121 +0.7948000000000001 0.6774862999525271 0.6774837385054603 -4.776703347933453e-07 -0.08359438051260924 +0.7949 0.6774947364601377 0.6774921842520418 -4.91357553270011e-07 -0.08359895553083063 +0.795 0.6775031705789185 0.6775006278897271 -5.049469107426541e-07 -0.08360352938716689 +0.7951 0.6775116023104134 0.6775090694179952 -5.184355437032329e-07 -0.08360810208184963 +0.7952 0.6775200316561949 0.6775175088362954 -5.318206102722378e-07 -0.0836126736151103 +0.7953000000000001 0.6775284586178646 0.677525946144048 -5.450992910382979e-07 -0.08361724398718041 +0.7954000000000001 0.6775368831970532 0.6775343813406449 -5.582687893773697e-07 -0.08362181319829148 +0.7955 0.6775453053954199 0.6775428144254485 -5.713263322715267e-07 -0.08362638124867501 +0.7956 0.6775537252146517 0.6775512453977934 -5.842691707669267e-07 -0.08363094813856244 +0.7957000000000001 0.6775621426564642 0.6775596742569858 -5.970945806260675e-07 -0.08363551386818524 +0.7958000000000001 0.6775705577226006 0.6775681010023039 -6.097998628412649e-07 -0.08364007843777488 +0.7959 0.6775789704148314 0.6775765256329985 -6.22382344231398e-07 -0.08364464184756282 +0.796 0.6775873807349546 0.6775849481482927 -6.348393779831429e-07 -0.08364920409778048 +0.7961 0.6775957886847954 0.6775933685473828 -6.471683442754728e-07 -0.0836537651886593 +0.7962 0.6776041942662048 0.6776017868294382 -6.593666507792584e-07 -0.08365832512043064 +0.7963000000000001 0.6776125974810611 0.6776102029936018 -6.714317331568687e-07 -0.08366288389332599 +0.7964000000000001 0.6776209983312682 0.67761861703899 -6.833610557144265e-07 -0.08366744150757668 +0.7965 0.6776293968187559 0.6776270289646935 -6.951521118597759e-07 -0.08367199796341407 +0.7966 0.6776377929454798 0.6776354387697774 -7.068024246437155e-07 -0.08367655326106957 +0.7967000000000001 0.6776461867134203 0.6776438464532812 -7.183095473012324e-07 -0.08368110740077453 +0.7968000000000001 0.6776545781245829 0.6776522520142201 -7.296710637094694e-07 -0.08368566038276035 +0.7969 0.6776629671809975 0.6776606554515838 -7.408845890538585e-07 -0.08369021220725831 +0.797 0.6776713538847183 0.6776690567643378 -7.519477700779209e-07 -0.08369476287449971 +0.7971 0.6776797382378235 0.6776774559514238 -7.62858285846546e-07 -0.08369931238471595 +0.7972 0.677688120242415 0.6776858530117597 -7.736138480235466e-07 -0.08370386073813832 +0.7973000000000001 0.6776964999006174 0.6776942479442399 -7.842122014128927e-07 -0.08370840793499806 +0.7974000000000001 0.6777048772145784 0.6777026407477363 -7.946511246109678e-07 -0.08371295397552653 +0.7975 0.6777132521864686 0.6777110314210975 -8.049284301453463e-07 -0.08371749885995491 +0.7976 0.6777216248184803 0.6777194199631498 -8.150419652519503e-07 -0.08372204258851448 +0.7977000000000001 0.6777299951128279 0.6777278063726979 -8.249896120415823e-07 -0.08372658516143655 +0.7978000000000001 0.6777383630717475 0.6777361906485252 -8.347692881521818e-07 -0.08373112657895238 +0.7979 0.6777467286974956 0.6777445727893929 -8.44378947137403e-07 -0.08373566684129313 +0.798 0.6777550919923498 0.6777529527940422 -8.538165789245822e-07 -0.08374020594869003 +0.7981 0.6777634529586081 0.6777613306611936 -8.630802101478041e-07 -0.08374474390137428 +0.7982 0.6777718115985885 0.6777697063895476 -8.721679046058695e-07 -0.08374928069957717 +0.7983000000000001 0.677780167914628 0.6777780799777844 -8.810777636231171e-07 -0.08375381634352977 +0.7984000000000001 0.6777885219090836 0.6777864514245657 -8.898079266461689e-07 -0.0837583508334633 +0.7985 0.6777968735843305 0.6777948207285338 -8.983565713965858e-07 -0.08376288416960892 +0.7986 0.6778052229427624 0.6778031878883126 -9.067219142316896e-07 -0.08376741635219775 +0.7987000000000001 0.6778135699867913 0.6778115529025084 -9.149022107968197e-07 -0.08377194738146104 +0.7988000000000001 0.6778219147188466 0.6778199157697088 -9.228957561779882e-07 -0.08377647725762985 +0.7989 0.6778302571413741 0.6778282764884843 -9.307008853320919e-07 -0.08378100598093523 +0.799 0.6778385972568377 0.6778366350573892 -9.383159733367119e-07 -0.08378553355160832 +0.7991 0.6778469350677169 0.6778449914749609 -9.457394358203253e-07 -0.0837900599698803 +0.7992 0.6778552705765071 0.6778533457397209 -9.529697291982275e-07 -0.08379458523598221 +0.7993000000000001 0.6778636037857195 0.6778616978501748 -9.600053513525442e-07 -0.08379910935014513 +0.7994000000000001 0.6778719346978798 0.6778700478048131 -9.668448413824304e-07 -0.0838036323126001 +0.7995 0.6778802633155288 0.6778783956021115 -9.734867803812275e-07 -0.08380815412357814 +0.7996 0.6778885896412215 0.6778867412405316 -9.799297913115623e-07 -0.08381267478331036 +0.7997000000000001 0.6778969136775268 0.6778950847185208 -9.86172539713115e-07 -0.08381719429202777 +0.7998000000000001 0.6779052354270263 0.6779034260345131 -9.922137338413961e-07 -0.08382171264996136 +0.7999 0.677913554892315 0.6779117651869295 -9.980521247232588e-07 -0.08382622985734213 +0.8 0.6779218720760005 0.6779201021741789 -1.0036865067675205e-06 -0.08383074591440114 +0.8001 0.6779301869807018 0.6779284369946572 -1.00911571759843e-06 -0.08383526082136933 +0.8002 0.6779384996090501 0.6779367696467491 -1.0143386387773123e-06 -0.08383977457847763 +0.8003000000000001 0.677946809963687 0.6779451001288279 -1.0193541956360352e-06 -0.08384428718595703 +0.8004000000000001 0.6779551180472654 0.6779534284392565 -1.0241613576655872e-06 -0.08384879864403853 +0.8005 0.677963423862448 0.6779617545763872 -1.0287591387658779e-06 -0.08385330895295301 +0.8006 0.6779717274119073 0.677970078538562 -1.0331465974122711e-06 -0.08385781811293137 +0.8007000000000001 0.6779800286983251 0.6779784003241145 -1.0373228367943632e-06 -0.08386232612420459 +0.8008000000000001 0.6779883277243921 0.6779867199313685 -1.0412870050380274e-06 -0.08386683298700355 +0.8009000000000001 0.6779966244928073 0.6779950373586394 -1.0450382955107251e-06 -0.08387133870155912 +0.801 0.6780049190062772 0.678003352604235 -1.0485759467382394e-06 -0.08387584326810218 +0.8011 0.6780132112675161 0.6780116656664557 -1.0518992426544749e-06 -0.0838803466868636 +0.8012 0.6780215012792454 0.6780199765435941 -1.0550075129345249e-06 -0.08388484895807424 +0.8013000000000001 0.6780297890441925 0.678028285233937 -1.0579001328558935e-06 -0.08388935008196496 +0.8014000000000001 0.6780380745650911 0.6780365917357642 -1.0605765235760511e-06 -0.08389385005876657 +0.8015 0.6780463578446803 0.6780448960473507 -1.063036152326724e-06 -0.0838983488887099 +0.8016 0.6780546388857042 0.678053198166966 -1.0652785323306269e-06 -0.08390284657202576 +0.8017000000000001 0.6780629176909116 0.6780614980928743 -1.0673032229402413e-06 -0.08390734310894493 +0.8018000000000001 0.6780711942630553 0.6780697958233364 -1.0691098299708823e-06 -0.08391183849969819 +0.8019000000000001 0.6780794686048917 0.6780780913566093 -1.0706980052566095e-06 -0.08391633274451635 +0.802 0.6780877407191805 0.6780863846909464 -1.0720674474551384e-06 -0.08392082584363014 +0.8021 0.6780960106086839 0.678094675824598 -1.0732179013261955e-06 -0.0839253177972703 +0.8022 0.6781042782761664 0.6781029647558132 -1.0741491583421414e-06 -0.08392980860566766 +0.8023 0.6781125437243936 0.6781112514828377 -1.0748610565491923e-06 -0.08393429826905278 +0.8024000000000001 0.6781208069561335 0.6781195360039172 -1.0753534805119092e-06 -0.08393878678765651 +0.8025 0.6781290679741537 0.6781278183172958 -1.0756263613964645e-06 -0.08394327416170946 +0.8026 0.6781373267812227 0.6781360984212176 -1.075679677053909e-06 -0.08394776039144239 +0.8027000000000001 0.6781455833801089 0.6781443763139263 -1.0755134519646603e-06 -0.08395224547708596 +0.8028000000000001 0.6781538377735794 0.6781526519936667 -1.0751277571552365e-06 -0.08395672941887078 +0.8029000000000001 0.6781620899644004 0.6781609254586842 -1.0745227101427446e-06 -0.08396121221702753 +0.803 0.6781703399553363 0.6781691967072262 -1.0736984752957035e-06 -0.08396569387178689 +0.8031 0.67817858774915 0.6781774657375418 -1.0726552631956654e-06 -0.08397017438337946 +0.8032 0.6781868333486009 0.6781857325478824 -1.0713933311090607e-06 -0.08397465375203586 +0.8033 0.6781950767564457 0.6781939971365029 -1.0699129825431086e-06 -0.0839791319779867 +0.8034000000000001 0.6782033179754379 0.678202259501661 -1.068214567412351e-06 -0.08398360906146257 +0.8035 0.6782115570083261 0.6782105196416187 -1.0662984819553856e-06 -0.08398808500269402 +0.8036 0.6782197938578551 0.6782187775546427 -1.0641651683740427e-06 -0.08399255980191166 +0.8037000000000001 0.6782280285267642 0.6782270332390038 -1.0618151152774757e-06 -0.083997033459346 +0.8038000000000001 0.6782362610177877 0.6782352866929787 -1.059248856905004e-06 -0.08400150597522762 +0.8039000000000001 0.6782444913336536 0.6782435379148498 -1.0564669735979582e-06 -0.08400597734978707 +0.804 0.6782527194770835 0.6782517869029057 -1.053470091189057e-06 -0.0840104475832548 +0.8041 0.6782609454507922 0.6782600336554416 -1.0502588811689417e-06 -0.08401491667586135 +0.8042 0.678269169257487 0.6782682781707605 -1.0468340604918858e-06 -0.08401938462783723 +0.8043 0.6782773908998677 0.6782765204471727 -1.0431963913537512e-06 -0.08402385143941289 +0.8044000000000001 0.6782856103806255 0.6782847604829965 -1.039346681136477e-06 -0.08402831711081885 +0.8045 0.6782938277024431 0.6782929982765591 -1.0352857820472572e-06 -0.08403278164228553 +0.8046 0.6783020428679934 0.6783012338261964 -1.0310145909520063e-06 -0.08403724503404338 +0.8047000000000001 0.6783102558799403 0.6783094671302545 -1.0265340492920938e-06 -0.08404170728632279 +0.8048000000000001 0.6783184667409373 0.6783176981870891 -1.021845143112099e-06 -0.08404616839935426 +0.8049000000000001 0.6783266754536272 0.6783259269950661 -1.0169489022548994e-06 -0.08405062837336813 +0.805 0.678334882020642 0.6783341535525629 -1.0118464007780048e-06 -0.08405508720859482 +0.8051 0.6783430864446016 0.6783423778579676 -1.006538755954356e-06 -0.08405954490526468 +0.8052 0.678351288728115 0.6783505999096808 -1.0010271289662143e-06 -0.08406400146360812 +0.8053 0.6783594888737778 0.6783588197061151 -9.9531272385045e-07 -0.0840684568838555 +0.8054000000000001 0.6783676868841736 0.6783670372456954 -9.893967875818088e-07 -0.08407291116623716 +0.8055 0.6783758827618718 0.6783752525268599 -9.832806100451563e-07 -0.08407736431098338 +0.8056 0.6783840765094288 0.678383465548061 -9.769655231750551e-07 -0.08408181631832452 +0.8057000000000001 0.6783922681293868 0.6783916763077644 -9.704529010390317e-07 -0.0840862671884909 +0.8058000000000001 0.678400457624273 0.6783998848044505 -9.637441596432872e-07 -0.08409071692171279 +0.8059000000000001 0.6784086449966 0.6784080910366146 -9.568407562665637e-07 -0.08409516551822051 +0.806 0.6784168302488649 0.678416295002767 -9.497441895434111e-07 -0.08409961297824425 +0.8061 0.6784250133835488 0.6784244967014343 -9.424559987564196e-07 -0.08410405930201433 +0.8062 0.6784331944031166 0.6784326961311586 -9.349777638500978e-07 -0.08410850448976097 +0.8063 0.6784413733100165 0.6784408932904988 -9.273111048618832e-07 -0.08411294854171442 +0.8064000000000001 0.6784495501066796 0.6784490881780311 -9.194576815335642e-07 -0.08411739145810482 +0.8065 0.6784577247955197 0.6784572807923486 -9.114191933112803e-07 -0.0841218332391625 +0.8066 0.6784658973789324 0.6784654711320621 -9.031973784434655e-07 -0.08412627388511754 +0.8067000000000001 0.678474067859295 0.6784736591958012 -8.947940142028932e-07 -0.08413071339620018 +0.8068000000000001 0.6784822362389662 0.6784818449822134 -8.862109159013531e-07 -0.08413515177264055 +0.8069000000000001 0.6784904025202856 0.6784900284899653 -8.774499369590405e-07 -0.08413958901466882 +0.807 0.6784985667055734 0.6784982097177434 -8.68512968293933e-07 -0.08414402512251515 +0.8071 0.6785067287971299 0.6785063886642533 -8.59401938058113e-07 -0.08414846009640965 +0.8072 0.6785148887972346 0.678514565328221 -8.501188109855118e-07 -0.08415289393658237 +0.8073 0.6785230467081473 0.6785227397083926 -8.406655881976199e-07 -0.08415732664326353 +0.8074000000000001 0.6785312025321064 0.6785309118035356 -8.310443066344986e-07 -0.08416175821668312 +0.8075 0.6785393562713287 0.6785390816124386 -8.21257038666201e-07 -0.08416618865707125 +0.8076 0.6785475079280094 0.6785472491339115 -8.113058917735838e-07 -0.08417061796465797 +0.8077000000000001 0.6785556575043219 0.6785554143667865 -8.01193007868295e-07 -0.08417504613967333 +0.8078000000000001 0.6785638050024166 0.6785635773099177 -7.909205629458294e-07 -0.08417947318234738 +0.8079000000000001 0.6785719504244216 0.6785717379621823 -7.80490766613684e-07 -0.08418389909291013 +0.808 0.6785800937724421 0.6785798963224802 -7.699058617305354e-07 -0.08418832387159159 +0.8081 0.678588235048559 0.6785880523897345 -7.591681236707171e-07 -0.08419274751862177 +0.8082 0.6785963742548301 0.6785962061628924 -7.482798599911522e-07 -0.08419717003423062 +0.8083 0.6786045113932888 0.6786043576409246 -7.372434100150205e-07 -0.08420159141864814 +0.8084000000000001 0.6786126464659441 0.6786125068228265 -7.260611441239906e-07 -0.08420601167210423 +0.8085 0.6786207794747801 0.6786206537076178 -7.14735463522298e-07 -0.08421043079482891 +0.8086 0.678628910421756 0.6786287982943435 -7.03268799445711e-07 -0.08421484878705207 +0.8087000000000001 0.6786370393088057 0.6786369405820738 -6.916636127868303e-07 -0.08421926564900363 +0.8088000000000001 0.6786451661378374 0.6786450805699038 -6.799223935816112e-07 -0.08422368138091353 +0.8089000000000001 0.678653290910733 0.6786532182569553 -6.680476603293517e-07 -0.0842280959830116 +0.809 0.6786614136293483 0.6786613536423758 -6.560419597290146e-07 -0.08423250945552771 +0.8091 0.6786695342955124 0.6786694867253391 -6.439078659159492e-07 -0.08423692179869174 +0.8092 0.6786776529110281 0.6786776175050462 -6.316479798512686e-07 -0.08424133301273358 +0.8093 0.6786857694776703 0.6786857459807247 -6.19264928988783e-07 -0.08424574309788302 +0.8094000000000001 0.6786938839971873 0.6786938721516296 -6.067613665533544e-07 -0.08425015205436992 +0.8095 0.6787019964712993 0.6787019960170431 -5.941399710829298e-07 -0.08425455988242406 +0.8096 0.6787101069016988 0.6787101175762755 -5.81403445720774e-07 -0.08425896658227527 +0.8097000000000001 0.6787182152900497 0.6787182368286648 -5.68554517785258e-07 -0.08426337215415326 +0.8098000000000001 0.6787263216379883 0.6787263537735775 -5.555959380204589e-07 -0.08426777659828787 +0.8099000000000001 0.6787344259471213 0.6787344684104086 -5.425304802214592e-07 -0.08427217991490879 +0.81 0.6787425282190274 0.6787425807385816 -5.293609403739241e-07 -0.0842765821042458 +0.8101 0.678750628455256 0.6787506907575493 -5.160901363765458e-07 -0.08428098316652863 +0.8102 0.678758726657327 0.6787587984667934 -5.027209071389871e-07 -0.08428538310198701 +0.8103 0.6787668228267307 0.678766903865825 -4.892561121586092e-07 -0.08428978191085063 +0.8104000000000001 0.6787749169649278 0.6787750069541846 -4.7569863082658204e-07 -0.08429417959334912 +0.8105 0.6787830090733491 0.6787831077314431 -4.620513618311395e-07 -0.08429857614971224 +0.8106 0.6787910991533953 0.6787912061972006 -4.48317222595529e-07 -0.08430297158016957 +0.8107000000000001 0.6787991872064368 0.6787993023510879 -4.34499148591061e-07 -0.08430736588495076 +0.8108000000000001 0.6788072732338136 0.6788073961927664 -4.2060009273342525e-07 -0.08431175906428555 +0.8109000000000001 0.678815357236835 0.6788154877219273 -4.066230246818625e-07 -0.08431615111840347 +0.811 0.678823439216779 0.6788235769382929 -3.9257093035344193e-07 -0.08432054204753414 +0.8111 0.6788315191748931 0.6788316638416163 -3.7844681116672163e-07 -0.08432493185190715 +0.8112 0.6788395971123937 0.6788397484316815 -3.6425368346582054e-07 -0.08432932053175209 +0.8113 0.6788476730304656 0.6788478307083039 -3.499945777848956e-07 -0.08433370808729851 +0.8114000000000001 0.6788557469302621 0.67885591067133 -3.3567253830690813e-07 -0.08433809451877594 +0.8115 0.6788638188129053 0.6788639883206378 -3.2129062219055093e-07 -0.08434247982641392 +0.8116 0.6788718886794853 0.678872063656137 -3.0685189883472574e-07 -0.08434686401044203 +0.8117000000000001 0.6788799565310605 0.6788801366777688 -2.9235944937200387e-07 -0.08435124707108971 +0.8118000000000001 0.6788880223686572 0.6788882073855063 -2.778163658498367e-07 -0.08435562900858647 +0.8119000000000001 0.67889608619327 0.6788962757793546 -2.6322575071013876e-07 -0.08436000982316183 +0.812 0.678904148005861 0.6789043418593507 -2.485907160433565e-07 -0.08436438951504523 +0.8121 0.6789122078073602 0.6789124056255635 -2.3391438294315114e-07 -0.08436876808446614 +0.8122 0.6789202655986648 0.6789204670780944 -2.191998808333262e-07 -0.08437314553165391 +0.8123 0.6789283213806404 0.6789285262170768 -2.044503468398573e-07 -0.08437752185683801 +0.8124000000000001 0.6789363751541196 0.6789365830426769 -1.8966892507965571e-07 -0.0843818970602479 +0.8125 0.6789444269199026 0.6789446375550932 -1.7485876602912898e-07 -0.08438627114211293 +0.8126 0.6789524766787571 0.6789526897545561 -1.600230258164137e-07 -0.0843906441026625 +0.8127000000000001 0.6789605244314179 0.6789607396413293 -1.4516486555350705e-07 -0.084395015942126 +0.8128000000000001 0.6789685701785866 0.6789687872157086 -1.3028745068748016e-07 -0.08439938666073273 +0.8129000000000001 0.6789766139209332 0.6789768324780228 -1.15393950304854e-07 -0.08440375625871206 +0.813 0.678984655659094 0.6789848754286327 -1.004875364654656e-07 -0.08440812473629328 +0.8131 0.6789926953936729 0.6789929160679324 -8.557138352245641e-08 -0.08441249209370574 +0.8132 0.6790007331252408 0.6790009543963487 -7.064866745266907e-08 -0.08441685833117873 +0.8133 0.6790087688543356 0.6790089904143404 -5.572256517099791e-08 -0.08442122344894148 +0.8134000000000001 0.6790168025814628 0.6790170241223998 -4.079625385796683e-08 -0.08442558744722332 +0.8135 0.6790248343070947 0.6790250555210517 -2.587291028849966e-08 -0.08442995032625351 +0.8136 0.679032864031671 0.6790330846108533 -1.0955710148547598e-08 -0.08443431208626126 +0.8137000000000001 0.6790408917555983 0.6790411113923949 3.952172636899343e-09 -0.08443867272747584 +0.8138000000000001 0.6790489174792508 0.6790491358662991 1.884756658035447e-08 -0.08444303225012642 +0.8139000000000001 0.6790569412029691 0.6790571580332211 3.3727303307834466e-08 -0.08444739065444216 +0.814 0.6790649629270621 0.6790651778938491 4.858821823702786e-08 -0.0844517479406523 +0.8141 0.6790729826518054 0.6790731954489037 6.342715123779097e-08 -0.084456104108986 +0.8142 0.6790810003774421 0.6790812106991375 7.824094732343523e-08 -0.08446045915967239 +0.8143 0.6790890161041827 0.6790892236453361 9.302645730471792e-08 -0.08446481309294061 +0.8144000000000001 0.6790970298322053 0.6790972342883177 1.0778053844903712e-07 -0.08446916590901982 +0.8145 0.6791050415616556 0.6791052426289319 1.2250005520381135e-07 -0.0844735176081391 +0.8146 0.6791130512926467 0.6791132486680611 1.3718187980016339e-07 -0.08447786819052755 +0.8147000000000001 0.6791210590252597 0.6791212524066201 1.5182289294854434e-07 -0.08448221765641428 +0.8148000000000001 0.6791290647595428 0.6791292538455551 1.664199845048675e-07 -0.08448656600602829 +0.8149000000000001 0.6791370684955133 0.6791372529858446 1.8097005409847822e-07 -0.08449091323959868 +0.815 0.6791450702331555 0.6791452498284989 1.9547001184339052e-07 -0.08449525935735447 +0.8151 0.6791530699724229 0.67915324437456 2.0991677897319594e-07 -0.08449960435952475 +0.8152 0.6791610677132358 0.6791612366251016 2.2430728845862502e-07 -0.08450394824633843 +0.8153 0.6791690634554841 0.6791692265812286 2.3863848572919233e-07 -0.08450829101802454 +0.8154000000000001 0.6791770571990255 0.6791772142440775 2.5290732926647186e-07 -0.08451263267481206 +0.8155 0.6791850489436873 0.6791851996148159 2.6711079125635306e-07 -0.08451697321692997 +0.8156 0.6791930386892644 0.6791931826946427 2.8124585826211357e-07 -0.08452131264460722 +0.8157000000000001 0.6792010264355214 0.6792011634847872 2.9530953182810293e-07 -0.08452565095807274 +0.8158000000000001 0.6792090121821915 0.6792091419865098 3.0929882918750984e-07 -0.08452998815755541 +0.8159000000000001 0.6792169959289778 0.6792171182011015 3.232107837966569e-07 -0.08453432424328416 +0.816 0.6792249776755527 0.6792250921298835 3.3704244600113453e-07 -0.08453865921548792 +0.8161 0.6792329574215579 0.6792330637742074 3.507908836741791e-07 -0.08454299307439551 +0.8162 0.6792409351666049 0.6792410331354546 3.644531829036235e-07 -0.08454732582023579 +0.8163 0.6792489109102758 0.6792490002150369 3.780264484706808e-07 -0.08455165745323767 +0.8164000000000001 0.6792568846521223 0.6792569650143951 3.915078045785281e-07 -0.08455598797362993 +0.8165 0.679264856391667 0.679264927535 4.048943953866013e-07 -0.08456031738164142 +0.8166 0.6792728261284025 0.6792728877783509 4.1818338571142366e-07 -0.08456464567750088 +0.8167000000000001 0.679280793861793 0.6792808457459768 4.3137196151232793e-07 -0.08456897286143716 +0.8168000000000001 0.6792887595912731 0.6792888014394354 4.4445733060616277e-07 -0.08457329893367901 +0.8169000000000001 0.679296723316249 0.6792967548603126 4.574367231807708e-07 -0.0845776238944552 +0.817 0.6793046850360985 0.6793047060102229 4.7030739230846663e-07 -0.08458194774399443 +0.8171 0.6793126447501714 0.6793126548908088 4.830666147231932e-07 -0.08458627048252554 +0.8172 0.6793206024577887 0.679320601503741 4.957116912646109e-07 -0.08459059211027713 +0.8173 0.6793285581582443 0.679328545850717 5.08239947558109e-07 -0.08459491262747788 +0.8174000000000001 0.6793365118508046 0.6793364879334621 5.206487343617505e-07 -0.08459923203435654 +0.8175 0.6793444635347088 0.6793444277537288 5.329354283434284e-07 -0.08460355033114175 +0.8176 0.6793524132091688 0.6793523653132961 5.450974326082214e-07 -0.08460786751806215 +0.8177000000000001 0.6793603608733705 0.6793603006139698 5.571321770869719e-07 -0.08461218359534645 +0.8178000000000001 0.6793683065264731 0.6793682336575815 5.69037119341198e-07 -0.08461649856322317 +0.8179000000000001 0.679376250167609 0.679376164445989 5.808097448545269e-07 -0.08462081242192093 +0.818 0.6793841917958863 0.6793840929810762 5.924475677265839e-07 -0.08462512517166841 +0.8181 0.6793921314103861 0.6793920192647516 6.039481311587158e-07 -0.08462943681269411 +0.8182 0.6794000690101657 0.6793999432989486 6.153090078286905e-07 -0.08463374734522658 +0.8183 0.6794080045942565 0.6794078650856263 6.265278006539754e-07 -0.08463805676949444 +0.8184000000000001 0.6794159381616656 0.6794157846267679 6.37602143166438e-07 -0.08464236508572616 +0.8185 0.6794238697113757 0.6794237019243798 6.485296999980683e-07 -0.08464667229415024 +0.8186 0.6794317992423464 0.6794316169804933 6.593081674638457e-07 -0.08465097839499523 +0.8187000000000001 0.6794397267535128 0.6794395297971623 6.699352738531728e-07 -0.08465528338848956 +0.8188000000000001 0.6794476522437876 0.6794474403764648 6.804087801515202e-07 -0.08465958727486178 +0.8189000000000001 0.6794555757120592 0.6794553487205004 6.907264804567603e-07 -0.08466389005434029 +0.819 0.679463497157195 0.6794632548313919 7.008862022012119e-07 -0.08466819172715352 +0.8191 0.6794714165780391 0.6794711587112843 7.108858070398183e-07 -0.08467249229352991 +0.8192 0.6794793339734144 0.6794790603623435 7.207231908779033e-07 -0.08467679175369787 +0.8193 0.679487249342122 0.6794869597867574 7.30396284578938e-07 -0.08468109010788581 +0.8194000000000001 0.679495162682942 0.6794948569867348 7.39903054311486e-07 -0.08468538735632208 +0.8195 0.6795030739946334 0.679502751964505 7.492415019794141e-07 -0.08468968349923504 +0.8196 0.6795109832759352 0.6795106447223178 7.584096657908823e-07 -0.08469397853685307 +0.8197000000000001 0.6795188905255661 0.6795185352624423 7.674056203693658e-07 -0.08469827246940444 +0.8198000000000001 0.6795267957422253 0.679526423587168 7.762274774059108e-07 -0.08470256529711753 +0.8199000000000001 0.6795346989245927 0.6795343096988027 7.848733859366908e-07 -0.08470685702022063 +0.82 0.6795426000713295 0.679542193599673 7.933415328148508e-07 -0.08471114763894196 +0.8201 0.6795504991810782 0.6795500752921244 8.01630143015819e-07 -0.08471543715350985 +0.8202 0.6795583962524634 0.67955795477852 8.097374801646628e-07 -0.08471972556415255 +0.8203 0.6795662912840917 0.6795658320612403 8.176618466193553e-07 -0.08472401287109832 +0.8204000000000001 0.6795741842745529 0.6795737071426831 8.254015841091533e-07 -0.08472829907457528 +0.8205 0.6795820752224196 0.6795815800252625 8.329550739566427e-07 -0.08473258417481173 +0.8206 0.6795899641262482 0.67958945071141 8.403207374108046e-07 -0.08473686817203585 +0.8207000000000001 0.6795978509845786 0.6795973192035716 8.474970359662048e-07 -0.08474115106647583 +0.8208000000000001 0.6796057357959356 0.6796051855042099 8.544824717654498e-07 -0.08474543285835975 +0.8209000000000001 0.6796136185588287 0.6796130496158017 8.612755878351086e-07 -0.08474971354791583 +0.821 0.6796214992717525 0.6796209115408389 8.678749684881693e-07 -0.08475399313537216 +0.8211 0.6796293779331872 0.6796287712818275 8.742792394905718e-07 -0.08475827162095684 +0.8212 0.6796372545415995 0.6796366288412875 8.80487068435909e-07 -0.08476254900489806 +0.8213 0.6796451290954417 0.6796444842217519 8.864971650091036e-07 -0.08476682528742376 +0.8214000000000001 0.6796530015931542 0.6796523374257666 8.923082812639649e-07 -0.08477110046876213 +0.8215 0.6796608720331638 0.6796601884558902 8.979192118452328e-07 -0.08477537454914111 +0.8216 0.6796687404138861 0.6796680373146933 9.033287942106227e-07 -0.08477964752878882 +0.8217000000000001 0.6796766067337243 0.6796758840047575 9.085359090610368e-07 -0.08478391940793324 +0.8218000000000001 0.6796844709910705 0.6796837285286763 9.135394803405639e-07 -0.08478819018680239 +0.8219000000000001 0.6796923331843063 0.6796915708890537 9.183384755695467e-07 -0.08479245986562427 +0.822 0.6797001933118023 0.6796994110885033 9.229319061498931e-07 -0.08479672844462677 +0.8221 0.6797080513719194 0.6797072491296494 9.273188273095645e-07 -0.08480099592403789 +0.8222 0.6797159073630098 0.6797150850151248 9.314983385466657e-07 -0.08480526230408564 +0.8223 0.6797237612834157 0.6797229187475715 9.354695838514893e-07 -0.08480952758499782 +0.8224000000000001 0.6797316131314712 0.6797307503296404 9.392317514844706e-07 -0.08481379176700246 +0.8225 0.6797394629055022 0.6797385797639892 9.427840747255889e-07 -0.08481805485032734 +0.8226 0.6797473106038268 0.6797464070532842 9.461258315413001e-07 -0.08482231683520036 +0.8227000000000001 0.6797551562247568 0.6797542322001979 9.492563448898483e-07 -0.08482657772184943 +0.8228000000000001 0.6797629997665962 0.6797620552074095 9.52174983082088e-07 -0.0848308375105023 +0.8229000000000001 0.6797708412276439 0.6797698760776048 9.548811595039286e-07 -0.0848350962013869 +0.823 0.6797786806061918 0.6797776948134744 9.573743330326678e-07 -0.08483935379473094 +0.8231 0.6797865179005276 0.6797855114177147 9.596540081480143e-07 -0.08484361029076226 +0.8232 0.6797943531089335 0.6797933258930264 9.617197349875983e-07 -0.08484786568970865 +0.8233 0.6798021862296882 0.6798011382421149 9.635711090971721e-07 -0.08485211999179788 +0.8234000000000001 0.6798100172610656 0.6798089484676886 9.652077721522545e-07 -0.0848563731972577 +0.8235 0.6798178462013367 0.6798167565724592 9.666294115417973e-07 -0.0848606253063158 +0.8236 0.6798256730487693 0.6798245625591419 9.678357605347188e-07 -0.08486487631919992 +0.8237000000000001 0.6798334978016289 0.6798323664304533 9.688265984741928e-07 -0.08486912623613768 +0.8238000000000001 0.6798413204581797 0.6798401681891124 9.69601750638871e-07 -0.08487337505735687 +0.8239000000000001 0.6798491410166834 0.6798479678378393 9.701610883816603e-07 -0.08487762278308508 +0.824 0.6798569594754009 0.6798557653793553 9.705045291574788e-07 -0.08488186941355003 +0.8241 0.679864775832593 0.6798635608163817 9.706320365232557e-07 -0.08488611494897925 +0.8242 0.6798725900865201 0.6798713541516399 9.70543619971398e-07 -0.08489035938960043 +0.8243 0.6798804022354433 0.6798791453878507 9.70239335318368e-07 -0.0848946027356412 +0.8244000000000001 0.6798882122776244 0.6798869345277336 9.697192841495728e-07 -0.08489884498732907 +0.8245 0.6798960202113262 0.6798947215740072 9.68983614207941e-07 -0.08490308614489157 +0.8246 0.6799038260348144 0.6799025065293876 9.680325193661687e-07 -0.08490732620855641 +0.8247000000000001 0.6799116297463557 0.6799102893965883 9.668662391826288e-07 -0.08491156517855097 +0.8248000000000001 0.6799194313442206 0.6799180701783206 9.654850592621944e-07 -0.08491580305510282 +0.8249000000000001 0.6799272308266822 0.6799258488772917 9.638893111174607e-07 -0.08492003983843943 +0.825 0.6799350281920176 0.6799336254962051 9.620793717524112e-07 -0.08492427552878827 +0.8251000000000001 0.6799428234385085 0.6799414000377602 9.600556640232405e-07 -0.08492851012637688 +0.8252 0.6799506165644411 0.6799491725046514 9.578186564163094e-07 -0.08493274363143272 +0.8253 0.6799584075681063 0.6799569428995675 9.553688626595669e-07 -0.08493697604418318 +0.8254000000000001 0.6799661964478008 0.6799647112251922 9.527068419168394e-07 -0.08494120736485566 +0.8255 0.6799739832018277 0.679972477484202 9.498331985102748e-07 -0.08494543759367755 +0.8256 0.6799817678284963 0.679980241679268 9.467485819480981e-07 -0.0849496667308763 +0.8257000000000001 0.6799895503261232 0.6799880038130528 9.434536867303223e-07 -0.08495389477667925 +0.8258000000000001 0.6799973306930323 0.6799957638882124 9.399492518769037e-07 -0.08495812173131373 +0.8259000000000001 0.6800051089275556 0.6800035219073943 9.362360613440757e-07 -0.08496234759500715 +0.826 0.680012885028033 0.680011277873237 9.323149433304589e-07 -0.08496657236798667 +0.8261000000000001 0.6800206589928143 0.680019031788371 9.28186770332573e-07 -0.08497079605047977 +0.8262 0.6800284308202575 0.6800267836554164 9.238524590060582e-07 -0.08497501864271363 +0.8263 0.680036200508731 0.680034533476984 9.193129697215863e-07 -0.08497924014491552 +0.8264000000000001 0.6800439680566133 0.6800422812556737 9.145693066758831e-07 -0.08498346055731272 +0.8265 0.6800517334622935 0.680050026994075 9.09622517392128e-07 -0.08498767988013248 +0.8266 0.6800594967241721 0.6800577706947661 9.044736927477093e-07 -0.08499189811360197 +0.8267 0.6800672578406608 0.6800655123603137 8.991239663913575e-07 -0.08499611525794845 +0.8268000000000001 0.6800750168101832 0.6800732519932713 8.935745147709007e-07 -0.08500033131339904 +0.8269000000000001 0.6800827736311759 0.6800809895961812 8.878265569944865e-07 -0.08500454628018095 +0.827 0.6800905283020877 0.6800887251715719 8.818813541089376e-07 -0.08500876015852131 +0.8271000000000001 0.6800982808213815 0.6800964587219585 8.757402091552624e-07 -0.08501297294864726 +0.8272 0.6801060311875333 0.6801041902498424 8.69404466918855e-07 -0.08501718465078593 +0.8273 0.6801137793990335 0.6801119197577106 8.628755134715282e-07 -0.08502139526516443 +0.8274000000000001 0.6801215254543871 0.6801196472480349 8.561547759078358e-07 -0.08502560479200977 +0.8275 0.6801292693521144 0.6801273727232725 8.492437221507831e-07 -0.08502981323154907 +0.8276 0.6801370110907505 0.6801350961858654 8.421438604661047e-07 -0.08503402058400941 +0.8277 0.6801447506688469 0.6801428176382385 8.348567392402195e-07 -0.08503822684961776 +0.8278000000000001 0.6801524880849712 0.6801505370828009 8.273839466471644e-07 -0.08504243202860115 +0.8279000000000001 0.6801602233377075 0.680158254521945 8.197271102461379e-07 -0.0850466361211866 +0.828 0.6801679564256574 0.6801659699580457 8.118878966623111e-07 -0.08505083912760106 +0.8281000000000001 0.6801756873474397 0.6801736833934604 8.038680112398833e-07 -0.08505504104807154 +0.8282 0.6801834161016911 0.6801813948305284 7.956691976118702e-07 -0.08505924188282493 +0.8283 0.6801911426870664 0.6801891042715709 7.872932374225483e-07 -0.08506344163208822 +0.8284000000000001 0.6801988671022393 0.6801968117188897 7.787419498556103e-07 -0.08506764029608829 +0.8285 0.6802065893459025 0.6802045171747679 7.700171912594644e-07 -0.08507183787505201 +0.8286 0.6802143094167683 0.6802122206414689 7.61120854744779e-07 -0.0850760343692063 +0.8287 0.6802220273135686 0.6802199221212359 7.520548699208041e-07 -0.08508022977877802 +0.8288000000000001 0.6802297430350555 0.6802276216162921 7.42821202159849e-07 -0.085084424103994 +0.8289000000000001 0.6802374565800013 0.6802353191288403 7.334218524446268e-07 -0.08508861734508111 +0.829 0.6802451679472 0.6802430146610614 7.23858856882531e-07 -0.08509280950226611 +0.8291000000000001 0.6802528771354661 0.6802507082151152 7.141342861782807e-07 -0.0850970005757758 +0.8292 0.6802605841436364 0.6802583997931404 7.042502453008526e-07 -0.08510119056583698 +0.8293 0.680268288970569 0.6802660893972526 6.942088728589813e-07 -0.08510537947267638 +0.8294000000000001 0.6802759916151448 0.6802737770295455 6.840123408652365e-07 -0.08510956729652074 +0.8295 0.6802836920762672 0.68028146269209 6.736628541254008e-07 -0.0851137540375968 +0.8296 0.6802913903528623 0.6802891463869336 6.631626497805021e-07 -0.08511793969613131 +0.8297 0.6802990864438802 0.6802968281161006 6.525139968072136e-07 -0.08512212427235089 +0.8298000000000001 0.6803067803482941 0.6803045078815912 6.417191956431534e-07 -0.08512630776648221 +0.8299000000000001 0.6803144720651011 0.6803121856853818 6.307805775346287e-07 -0.08513049017875195 +0.83 0.680322161593323 0.680319861529424 6.197005041203019e-07 -0.08513467150938672 +0.8301000000000001 0.680329848932006 0.6803275354156451 6.084813669038347e-07 -0.08513885175861316 +0.8302 0.6803375340802214 0.6803352073459472 5.971255867404102e-07 -0.08514303092665793 +0.8303 0.6803452170370654 0.6803428773222069 5.856356133510099e-07 -0.0851472090137475 +0.8304000000000001 0.6803528978016596 0.6803505453462754 5.740139247256693e-07 -0.08515138602010858 +0.8305 0.6803605763731518 0.6803582114199775 5.622630266516326e-07 -0.08515556194596759 +0.8306 0.6803682527507156 0.6803658755451124 5.503854521443641e-07 -0.08515973679155112 +0.8307 0.680375926933551 0.6803735377234523 5.383837609201914e-07 -0.08516391055708566 +0.8308000000000001 0.6803835989208844 0.6803811979567432 5.262605388550723e-07 -0.08516808324279772 +0.8309000000000001 0.6803912687119696 0.6803888562467035 5.140183973045831e-07 -0.0851722548489138 +0.831 0.680398936306087 0.6803965125950246 5.016599726875848e-07 -0.08517642537566034 +0.8311000000000001 0.6804066017025447 0.6804041670033706 4.891879259588672e-07 -0.0851805948232638 +0.8312 0.6804142649006784 0.6804118194733773 4.7660494185974844e-07 -0.0851847631919506 +0.8313 0.6804219258998514 0.6804194700066526 4.639137285017414e-07 -0.08518893048194714 +0.8314000000000001 0.6804295846994556 0.6804271186047762 4.511170166865419e-07 -0.0851930966934798 +0.8315 0.680437241298911 0.6804347652692996 4.3821755936479523e-07 -0.085197261826775 +0.8316 0.6804448956976661 0.6804424100017452 4.2521813102547323e-07 -0.08520142588205909 +0.8317 0.6804525478951984 0.6804500528036066 4.1212152708525185e-07 -0.08520558885955837 +0.8318000000000001 0.6804601978910142 0.6804576936763482 3.989305633472773e-07 -0.08520975075949921 +0.8319000000000001 0.6804678456846488 0.6804653326214054 3.8564807530727663e-07 -0.08521391158210787 +0.832 0.6804754912756676 0.6804729696401832 3.72276917688652e-07 -0.08521807132761063 +0.8321000000000001 0.6804831346636651 0.6804806047340577 3.5881996361675217e-07 -0.08522222999623381 +0.8322 0.6804907758482655 0.6804882379043746 3.4528010422335553e-07 -0.08522638758820361 +0.8323 0.6804984148291233 0.68049586915245 3.3166024789033077e-07 -0.0852305441037463 +0.8324000000000001 0.6805060516059228 0.6805034984795686 3.179633196598308e-07 -0.08523469954308802 +0.8325 0.6805136861783792 0.6805111258869859 3.0419226058203686e-07 -0.08523885390645504 +0.8326 0.6805213185462374 0.6805187513759263 2.903500271322912e-07 -0.08524300719407354 +0.8327 0.6805289487092736 0.6805263749475834 2.7643959056578016e-07 -0.0852471594061697 +0.8328000000000001 0.6805365766672943 0.6805339966031198 2.624639362583392e-07 -0.0852513105429696 +0.8329000000000001 0.6805442024201371 0.6805416163436669 2.4842606308195236e-07 -0.08525546060469939 +0.833 0.6805518259676708 0.6805492341703254 2.343289827178019e-07 -0.08525960959158523 +0.8331000000000001 0.6805594473097949 0.6805568500841643 2.2017571910809552e-07 -0.08526375750385311 +0.8332 0.6805670664464405 0.6805644640862213 2.0596930774136046e-07 -0.08526790434172916 +0.8333 0.6805746833775707 0.6805720761775025 1.9171279496549287e-07 -0.08527205010543946 +0.8334000000000001 0.6805822981031788 0.6805796863589822 1.774092373979519e-07 -0.08527619479521002 +0.8335 0.6805899106232908 0.6805872946316033 1.630617012804425e-07 -0.08528033841126682 +0.8336 0.680597520937964 0.6805949009962764 1.4867326173992335e-07 -0.08528448095383591 +0.8337 0.6806051290472878 0.6806025054538807 1.3424700223002572e-07 -0.08528862242314328 +0.8338000000000001 0.6806127349513827 0.6806101080052624 1.1978601381287812e-07 -0.08529276281941482 +0.8339000000000001 0.6806203386504022 0.6806177086512368 1.0529339448603348e-07 -0.08529690214287655 +0.834 0.6806279401445311 0.6806253073925864 9.077224854756039e-08 -0.08530104039375438 +0.8341000000000001 0.6806355394339862 0.6806329042300614 7.622568595072599e-08 -0.08530517757227418 +0.8342 0.6806431365190172 0.68064049916438 6.165682155979957e-08 -0.08530931367866189 +0.8343 0.6806507313999053 0.6806480921962279 4.7068774574124395e-08 -0.08531344871314336 +0.8344000000000001 0.6806583240769642 0.6806556833262584 3.246466781514634e-08 -0.08531758267594447 +0.8345 0.6806659145505396 0.6806632725550926 1.7847627051606474e-08 -0.08532171556729101 +0.8346 0.68067350282101 0.6806708598833191 3.2207803438155658e-09 -0.08532584738740889 +0.8347 0.6806810888887855 0.6806784453114939 -1.1412742619877625e-08 -0.08532997813652382 +0.8348000000000001 0.6806886727543089 0.680686028840141 -2.604981120309796e-08 -0.08533410781486166 +0.8349000000000001 0.6806962544180553 0.6806936104697509 -4.068729449213139e-08 -0.08533823642264805 +0.835 0.680703833880532 0.6807011902007829 -5.532206196379348e-08 -0.08534236396010884 +0.8351000000000001 0.680711411142279 0.6807087680336633 -6.9950984149178e-08 -0.08534649042746978 +0.8352 0.6807189862038676 0.6807163439687858 -8.457093331019905e-08 -0.08535061582495651 +0.8353 0.6807265590659026 0.680723918006512 -9.917878410897751e-08 -0.08535474015279475 +0.8354000000000001 0.6807341297290199 0.6807314901471708 -1.1377141427050541e-07 -0.08535886341121014 +0.8355 0.6807416981938885 0.6807390603910595 -1.2834570524249134e-07 -0.0853629856004284 +0.8356 0.6807492644612091 0.6807466287384423 -1.4289854289618875e-07 -0.08536710672067513 +0.8357 0.6807568285317143 0.680754195189551 -1.5742681815957005e-07 -0.08537122677217593 +0.8358000000000001 0.6807643904061692 0.6807617597445864 -1.7192742768346037e-07 -0.08537534575515643 +0.8359000000000001 0.6807719500853705 0.6807693224037159 -1.863972745215492e-07 -0.08537946366984218 +0.836 0.6807795075701472 0.6807768831670756 -2.0083326876876861e-07 -0.08538358051645878 +0.8361000000000001 0.6807870628613595 0.6807844420347693 -2.1523232826906047e-07 -0.08538769629523173 +0.8362 0.6807946159599001 0.6807919990068689 -2.2959137918956984e-07 -0.0853918110063866 +0.8363 0.6808021668666928 0.6807995540834151 -2.439073567908623e-07 -0.08539592465014886 +0.8364000000000001 0.6808097155826933 0.6808071072644162 -2.5817720597162697e-07 -0.08540003722674405 +0.8365 0.6808172621088882 0.680814658549849 -2.7239788199032167e-07 -0.0854041487363976 +0.8366 0.6808248064462961 0.6808222079396592 -2.8656635109314266e-07 -0.08540825917933498 +0.8367 0.6808323485959662 0.6808297554337608 -3.006795911558724e-07 -0.08541236855578159 +0.8368000000000001 0.6808398885589794 0.6808373010320369 -3.147345923465439e-07 -0.08541647686596292 +0.8369000000000001 0.6808474263364469 0.6808448447343389 -3.2872835774994114e-07 -0.08542058411010428 +0.837 0.6808549619295114 0.6808523865404881 -3.4265790400250795e-07 -0.0854246902884311 +0.8371000000000001 0.6808624953393456 0.6808599264502742 -3.565202619862373e-07 -0.08542879540116873 +0.8372 0.680870026567153 0.6808674644634565 -3.7031247734214956e-07 -0.08543289944854249 +0.8373 0.6808775556141677 0.6808750005797639 -3.8403161126132623e-07 -0.08543700243077772 +0.8374000000000001 0.6808850824816537 0.6808825347988952 -3.976747410053272e-07 -0.08544110434809976 +0.8375 0.680892607170905 0.6808900671205182 -4.112389605168132e-07 -0.08544520520073379 +0.8376 0.6809001296832458 0.6808975975442719 -4.247213810856798e-07 -0.08544930498890521 +0.8377 0.6809076500200293 0.6809051260697643 -4.381191319804967e-07 -0.08545340371283915 +0.8378000000000001 0.6809151681826389 0.6809126526965744 -4.514293610036191e-07 -0.0854575013727609 +0.8379000000000001 0.6809226841724868 0.6809201774242519 -4.646492351711995e-07 -0.08546159796889567 +0.838 0.6809301979910144 0.6809277002523171 -4.777759412336047e-07 -0.08546569350146865 +0.8381000000000001 0.6809377096396919 0.6809352211802611 -4.90806686306855e-07 -0.08546978797070498 +0.8382000000000001 0.6809452191200184 0.6809427402075464 -5.037386985318193e-07 -0.08547388137682985 +0.8383 0.6809527264335211 0.6809502573336073 -5.165692275599376e-07 -0.08547797372006839 +0.8384000000000001 0.6809602315817553 0.6809577725578488 -5.292955452401715e-07 -0.08548206500064572 +0.8385 0.6809677345663049 0.6809652858796489 -5.419149461394213e-07 -0.0854861552187869 +0.8386 0.6809752353887808 0.6809727972983568 -5.544247480560038e-07 -0.08549024437471703 +0.8387 0.6809827340508217 0.6809803068132947 -5.668222927829314e-07 -0.08549433246866117 +0.8388000000000001 0.6809902305540932 0.6809878144237573 -5.791049464548559e-07 -0.08549841950084436 +0.8389000000000001 0.6809977249002888 0.680995320129012 -5.91270100269714e-07 -0.08550250547149163 +0.839 0.6810052170911274 0.6810028239282996 -6.0331517097445e-07 -0.08550659038082799 +0.8391000000000001 0.6810127071283555 0.6810103258208342 -6.152376014201266e-07 -0.08551067422907843 +0.8392000000000001 0.6810201950137449 0.6810178258058034 -6.270348610615262e-07 -0.0855147570164679 +0.8393 0.6810276807490935 0.681025323882369 -6.387044466649172e-07 -0.08551883874322132 +0.8394000000000001 0.6810351643362251 0.6810328200496671 -6.502438826133661e-07 -0.08552291940956365 +0.8395 0.6810426457769888 0.6810403143068084 -6.616507215451151e-07 -0.0855269990157198 +0.8396 0.6810501250732582 0.6810478066528782 -6.729225449503273e-07 -0.08553107756191466 +0.8397 0.681057602226932 0.681055297086937 -6.840569634763982e-07 -0.08553515504837311 +0.8398000000000001 0.6810650772399331 0.6810627856080207 -6.950516176912336e-07 -0.08553923147531994 +0.8399000000000001 0.6810725501142088 0.6810702722151414 -7.059041784440723e-07 -0.08554330684298002 +0.84 0.6810800208517298 0.6810777569072868 -7.166123472818198e-07 -0.08554738115157819 +0.8401000000000001 0.6810874894544905 0.681085239683421 -7.271738570457931e-07 -0.08555145440133922 +0.8402000000000001 0.6810949559245081 0.6810927205424855 -7.3758647244071e-07 -0.08555552659248788 +0.8403 0.6811024202638227 0.681100199483398 -7.47847990298367e-07 -0.08555959772524889 +0.8404 0.6811098824744972 0.6811076765050545 -7.579562401466289e-07 -0.08556366779984709 +0.8405 0.6811173425586163 0.6811151516063279 -7.679090847784176e-07 -0.08556773681650712 +0.8406 0.6811248005182862 0.6811226247860696 -7.777044205292682e-07 -0.08557180477545367 +0.8407 0.6811322563556351 0.6811300960431095 -7.873401777630518e-07 -0.08557587167691148 +0.8408000000000001 0.6811397100728117 0.6811375653762561 -7.96814321371575e-07 -0.08557993752110515 +0.8409000000000001 0.6811471616719857 0.6811450327842974 -8.061248512325481e-07 -0.08558400230825935 +0.841 0.681154611155347 0.6811524982660006 -8.152698025148952e-07 -0.0855880660385987 +0.8411000000000001 0.6811620585251056 0.6811599618201127 -8.242472461506001e-07 -0.0855921287123478 +0.8412000000000001 0.6811695037834906 0.6811674234453614 -8.330552892926724e-07 -0.0855961903297312 +0.8413 0.681176946932751 0.6811748831404549 -8.416920756759705e-07 -0.08560025089097348 +0.8414 0.6811843879751541 0.681182340904082 -8.501557860474129e-07 -0.08560431039629918 +0.8415 0.681191826912986 0.6811897967349139 -8.584446383602673e-07 -0.08560836884593287 +0.8416 0.6811992637485502 0.6811972506316026 -8.665568883986507e-07 -0.08561242624009902 +0.8417 0.6812066984841691 0.6812047025927828 -8.744908300967191e-07 -0.08561648257902213 +0.8418000000000001 0.681214131122181 0.6812121526170716 -8.822447958023449e-07 -0.08562053786292667 +0.8419000000000001 0.6812215616649415 0.6812196007030691 -8.898171567212065e-07 -0.08562459209203704 +0.842 0.6812289901148232 0.6812270468493591 -8.972063230694438e-07 -0.08562864526657771 +0.8421000000000001 0.681236416474214 0.6812344910545092 -9.044107447120364e-07 -0.0856326973867731 +0.8422000000000001 0.6812438407455177 0.681241933317071 -9.114289113154594e-07 -0.08563674845284759 +0.8423 0.6812512629311531 0.6812493736355804 -9.182593526807503e-07 -0.08564079846502551 +0.8424 0.6812586830335547 0.6812568120085589 -9.249006390071868e-07 -0.08564484742353126 +0.8425 0.6812661010551702 0.6812642484345135 -9.313513812808649e-07 -0.08564889532858916 +0.8426 0.6812735169984618 0.6812716829119366 -9.376102315383772e-07 -0.08565294218042349 +0.8427 0.6812809308659052 0.6812791154393077 -9.436758831027348e-07 -0.0856569879792586 +0.8428000000000001 0.6812883426599892 0.6812865460150923 -9.495470710135789e-07 -0.08566103272531869 +0.8429000000000001 0.6812957523832152 0.6812939746377437 -9.552225719994256e-07 -0.08566507641882809 +0.843 0.6813031600380968 0.6813014013057019 -9.607012050466546e-07 -0.08566911906001098 +0.8431000000000001 0.6813105656271593 0.6813088260173965 -9.65981831496654e-07 -0.08567316064909163 +0.8432000000000001 0.6813179691529395 0.6813162487712441 -9.710633552123538e-07 -0.08567720118629413 +0.8433 0.6813253706179851 0.6813236695656509 -9.759447229806817e-07 -0.08568124067184274 +0.8434 0.6813327700248542 0.6813310883990126 -9.806249246235854e-07 -0.08568527910596153 +0.8435 0.6813401673761148 0.6813385052697145 -9.85102993233955e-07 -0.08568931648887473 +0.8436 0.681347562674345 0.6813459201761325 -9.893780053837897e-07 -0.08569335282080642 +0.8437 0.681354955922131 0.681353333116633 -9.934490813601204e-07 -0.08569738810198074 +0.8438000000000001 0.6813623471220687 0.6813607440895733 -9.973153850539873e-07 -0.08570142233262167 +0.8439000000000001 0.6813697362767617 0.6813681530933032 -1.0009761246543292e-06 -0.08570545551295339 +0.844 0.6813771233888213 0.6813755601261637 -1.0044305523981834e-06 -0.08570948764319983 +0.8441000000000001 0.6813845084608658 0.6813829651864889 -1.007677964875997e-06 -0.08571351872358501 +0.8442000000000001 0.6813918914955213 0.6813903682726057 -1.0107177031981607e-06 -0.08571754875433296 +0.8443 0.6813992724954192 0.6813977693828347 -1.0135491530782748e-06 -0.08572157773566769 +0.8444 0.6814066514631973 0.6814051685154906 -1.0161717449719276e-06 -0.08572560566781316 +0.8445 0.6814140284014989 0.6814125656688819 -1.0185849541599623e-06 -0.08572963255099325 +0.8446 0.6814214033129717 0.6814199608413125 -1.0207883009427654e-06 -0.08573365838543186 +0.8447 0.6814287762002691 0.6814273540310813 -1.0227813505014893e-06 -0.08573768317135295 +0.8448000000000001 0.681436147066047 0.6814347452364835 -1.0245637134531638e-06 -0.08574170690898036 +0.8449000000000001 0.681443515912966 0.68144213445581 -1.0261350454898732e-06 -0.08574572959853798 +0.845 0.6814508827436896 0.681449521687349 -1.0274950475175348e-06 -0.08574975124024961 +0.8451000000000001 0.6814582475608832 0.6814569069293858 -1.0286434660444765e-06 -0.08575377183433913 +0.8452000000000001 0.6814656103672156 0.6814642901802028 -1.0295800926818366e-06 -0.08575779138103029 +0.8453 0.6814729711653561 0.6814716714380817 -1.030304764643164e-06 -0.0857618098805469 +0.8454 0.6814803299579759 0.6814790507013015 -1.030817364577885e-06 -0.08576582733311267 +0.8455 0.6814876867477465 0.6814864279681416 -1.0311178206545701e-06 -0.08576984373895138 +0.8456 0.6814950415373403 0.68149380323688 -1.0312061065054223e-06 -0.08577385909828675 +0.8457 0.6815023943294289 0.6815011765057952 -1.0310822411707665e-06 -0.08577787341134246 +0.8458000000000001 0.6815097451266834 0.6815085477731659 -1.0307462893488495e-06 -0.08578188667834218 +0.8459000000000001 0.6815170939317741 0.6815159170372723 -1.0301983610350174e-06 -0.0857858988995096 +0.846 0.6815244407473691 0.6815232842963956 -1.0294386118825383e-06 -0.08578991007506832 +0.8461000000000001 0.681531785576135 0.6815306495488194 -1.0284672426752461e-06 -0.08579392020524201 +0.8462000000000001 0.6815391284207354 0.6815380127928292 -1.0272844996883634e-06 -0.08579792929025426 +0.8463 0.681546469283831 0.6815453740267134 -1.025890674494212e-06 -0.0858019373303286 +0.8464 0.6815538081680794 0.6815527332487643 -1.0242861038511908e-06 -0.08580594432568867 +0.8465 0.6815611450761333 0.6815600904572775 -1.0224711696760203e-06 -0.0858099502765579 +0.8466 0.6815684800106421 0.6815674456505529 -1.0204462987661866e-06 -0.08581395518315989 +0.8467 0.6815758129742499 0.6815747988268954 -1.0182119632162756e-06 -0.08581795904571815 +0.8468000000000001 0.6815831439695947 0.6815821499846146 -1.0157686796685717e-06 -0.08582196186445606 +0.8469000000000001 0.6815904729993099 0.6815894991220264 -1.013117009590614e-06 -0.08582596363959714 +0.847 0.6815978000660217 0.6815968462374523 -1.0102575591086627e-06 -0.08582996437136481 +0.8471000000000001 0.6816051251723501 0.681604191329221 -1.007190978841166e-06 -0.08583396405998252 +0.8472000000000001 0.6816124483209077 0.6816115343956677 -1.0039179635656925e-06 -0.08583796270567366 +0.8473 0.6816197695142996 0.6816188754351354 -1.0004392523021988e-06 -0.08584196030866162 +0.8474 0.6816270887551223 0.6816262144459746 -9.96755628146495e-07 -0.08584595686916974 +0.8475 0.6816344060459645 0.681633551426545 -9.928679179649347e-07 -0.08584995238742135 +0.8476 0.6816417213894048 0.6816408863752146 -9.887769923111467e-07 -0.08585394686363973 +0.8477 0.6816490347880135 0.6816482192903608 -9.844837650097027e-07 -0.08585794029804826 +0.8478000000000001 0.6816563462443505 0.6816555501703707 -9.799891933781613e-07 -0.08586193269087015 +0.8479000000000001 0.6816636557609648 0.6816628790136419 -9.752942776442008e-07 -0.08586592404232864 +0.848 0.6816709633403956 0.6816702058185826 -9.70400060862353e-07 -0.08586991435264704 +0.8481000000000001 0.6816782689851701 0.6816775305836118 -9.653076286642026e-07 -0.08587390362204855 +0.8482000000000001 0.6816855726978042 0.6816848533071606 -9.600181091612425e-07 -0.08587789185075632 +0.8483 0.6816928744808011 0.6816921739876711 -9.545326724175185e-07 -0.08588187903899351 +0.8484 0.6817001743366522 0.681699492623599 -9.488525303802398e-07 -0.08588586518698332 +0.8485 0.6817074722678356 0.681706809213412 -9.429789365050789e-07 -0.08588985029494887 +0.8486 0.681714768276816 0.6817141237555915 -9.369131857006607e-07 -0.0858938343631133 +0.8487 0.6817220623660438 0.6817214362486322 -9.30656613815084e-07 -0.08589781739169966 +0.8488000000000001 0.6817293545379559 0.6817287466910434 -9.242105974693882e-07 -0.08590179938093101 +0.8489000000000001 0.681736644794974 0.6817360550813488 -9.175765536412195e-07 -0.08590578033103047 +0.849 0.6817439331395048 0.6817433614180866 -9.107559394289089e-07 -0.085909760242221 +0.8491000000000001 0.6817512195739397 0.6817506656998109 -9.037502518155494e-07 -0.08591373911472563 +0.8492000000000001 0.6817585041006536 0.6817579679250914 -8.965610272249069e-07 -0.08591771694876735 +0.8493 0.6817657867220059 0.6817652680925137 -8.891898411605981e-07 -0.08592169374456915 +0.8494 0.6817730674403387 0.681772566200681 -8.816383079562895e-07 -0.085925669502354 +0.8495 0.6817803462579768 0.6817798622482122 -8.739080804287536e-07 -0.08592964422234477 +0.8496 0.681787623177228 0.6817871562337443 -8.660008494199012e-07 -0.08593361790476436 +0.8497 0.6817948982003819 0.6817944481559319 -8.579183435053483e-07 -0.08593759054983574 +0.8498000000000001 0.6818021713297098 0.6818017380134478 -8.496623285364491e-07 -0.08594156215778175 +0.8499000000000001 0.6818094425674643 0.6818090258049831 -8.41234607473762e-07 -0.08594553272882517 +0.85 0.6818167119158789 0.6818163115292482 -8.326370197486721e-07 -0.08594950226318886 +0.8501000000000001 0.6818239793771678 0.6818235951849724 -8.238714409025683e-07 -0.08595347076109561 +0.8502000000000001 0.6818312449535251 0.681830876770905 -8.149397822954096e-07 -0.08595743822276819 +0.8503000000000001 0.6818385086471253 0.6818381562858153 -8.058439906200032e-07 -0.08596140464842941 +0.8504 0.6818457704601217 0.6818454337284932 -7.965860474995479e-07 -0.08596537003830204 +0.8505 0.6818530303946468 0.6818527090977485 -7.87167968988034e-07 -0.08596933439260869 +0.8506 0.6818602884528121 0.6818599823924133 -7.775918052232988e-07 -0.08597329771157217 +0.8507 0.6818675446367075 0.6818672536113402 -7.678596399829374e-07 -0.08597725999541508 +0.8508000000000001 0.6818747989484006 0.681874522753404 -7.579735901430684e-07 -0.08598122124436015 +0.8509000000000001 0.6818820513899371 0.6818817898175019 -7.479358052620011e-07 -0.08598518145862999 +0.851 0.6818893019633396 0.681889054802553 -7.377484672194123e-07 -0.0859891406384472 +0.8511 0.6818965506706084 0.6818963177074995 -7.274137894808241e-07 -0.08599309878403436 +0.8512000000000001 0.68190379751372 0.6819035785313068 -7.169340170282146e-07 -0.0859970558956141 +0.8513000000000001 0.6819110424946273 0.6819108372729638 -7.063114253330616e-07 -0.08600101197340895 +0.8514 0.6819182856152595 0.6819180939314828 -6.955483204534874e-07 -0.0860049670176414 +0.8515 0.6819255268775215 0.6819253485059007 -6.8464703802118e-07 -0.08600892102853404 +0.8516 0.6819327662832937 0.6819326009952784 -6.736099431164932e-07 -0.08601287400630936 +0.8517 0.6819400038344315 0.6819398513987018 -6.624394294496572e-07 -0.08601682595118978 +0.8518000000000001 0.6819472395327655 0.6819470997152812 -6.511379190971001e-07 -0.08602077686339776 +0.8519000000000001 0.6819544733801004 0.6819543459441528 -6.397078619185814e-07 -0.08602472674315574 +0.852 0.6819617053782157 0.681961590084478 -6.281517347939136e-07 -0.08602867559068611 +0.8521 0.6819689355288646 0.6819688321354441 -6.164720414703062e-07 -0.08603262340621132 +0.8522000000000001 0.6819761638337742 0.6819760720962644 -6.046713117435765e-07 -0.08603657018995364 +0.8523000000000001 0.681983390294645 0.6819833099661794 -5.927521009169157e-07 -0.08604051594213552 +0.8524 0.6819906149131507 0.6819905457444545 -5.807169894400666e-07 -0.08604446066297917 +0.8525 0.6819978376909382 0.6819977794303838 -5.685685821876785e-07 -0.08604840435270703 +0.8526 0.6820050586296267 0.682005011023287 -5.563095079874625e-07 -0.08605234701154124 +0.8527 0.6820122777308084 0.6820122405225124 -5.439424189124242e-07 -0.08605628863970416 +0.8528000000000001 0.6820194949960472 0.6820194679274354 -5.314699899200415e-07 -0.08606022923741799 +0.8529000000000001 0.6820267104268795 0.682026693237459 -5.188949180195968e-07 -0.08606416880490497 +0.853 0.682033924024813 0.6820339164520146 -5.062199219668662e-07 -0.08606810734238729 +0.8531 0.6820411357913276 0.6820411375705617 -4.934477414661465e-07 -0.08607204485008715 +0.8532000000000001 0.6820483457278739 0.6820483565925887 -4.805811367053492e-07 -0.08607598132822668 +0.8533000000000001 0.682055553835874 0.6820555735176119 -4.6762288764129467e-07 -0.08607991677702799 +0.8534 0.6820627601167208 0.6820627883451775 -4.5457579351398936e-07 -0.08608385119671326 +0.8535 0.6820699645717783 0.6820700010748599 -4.4144267216661426e-07 -0.0860877845875045 +0.8536 0.6820771672023804 0.6820772117062632 -4.282263594418412e-07 -0.08609171694962388 +0.8537 0.6820843680098319 0.682084420239021 -4.1492970868223233e-07 -0.08609564828329336 +0.8538000000000001 0.6820915669954075 0.6820916266727965 -4.015555899183898e-07 -0.08609957858873496 +0.8539000000000001 0.6820987641603524 0.6820988310072827 -3.8810688945262184e-07 -0.08610350786617073 +0.854 0.6821059595058813 0.6821060332422026 -3.745865091095424e-07 -0.08610743611582267 +0.8541 0.6821131530331785 0.6821132333773092 -3.609973656115706e-07 -0.08611136333791272 +0.8542000000000001 0.6821203447433981 0.6821204314123861 -3.4734239004463596e-07 -0.08611528953266283 +0.8543000000000001 0.6821275346376638 0.6821276273472471 -3.336245270671445e-07 -0.08611921470029496 +0.8544 0.6821347227170682 0.6821348211817364 -3.198467344658895e-07 -0.08612313884103094 +0.8545 0.6821419089826735 0.6821420129157292 -3.0601198238583427e-07 -0.08612706195509275 +0.8546 0.6821490934355101 0.6821492025491314 -2.9212325274030615e-07 -0.08613098404270214 +0.8547 0.6821562760765785 0.6821563900818797 -2.781835385101683e-07 -0.08613490510408106 +0.8548000000000001 0.6821634569068469 0.6821635755139419 -2.6419584321993317e-07 -0.08613882513945119 +0.8549000000000001 0.6821706359272528 0.682170758845317 -2.501631801953008e-07 -0.08614274414903439 +0.855 0.6821778131387026 0.6821779400760354 -2.360885718935557e-07 -0.08614666213305247 +0.8551 0.6821849885420703 0.6821851192061583 -2.2197504935886347e-07 -0.08615057909172712 +0.8552000000000001 0.6821921621381994 0.6821922962357793 -2.0782565145552323e-07 -0.08615449502528014 +0.8553000000000001 0.6821993339279008 0.6821994711650221 -1.936434242851004e-07 -0.08615840993393316 +0.8554 0.682206503911954 0.6822066439940432 -1.7943142053070127e-07 -0.0861623238179079 +0.8555 0.6822136720911074 0.6822138147230302 -1.651926987457364e-07 -0.08616623667742605 +0.8556 0.6822208384660765 0.6822209833522022 -1.5093032274676732e-07 -0.08617014851270921 +0.8557 0.6822280030375457 0.6822281498818102 -1.3664736093349505e-07 -0.08617405932397904 +0.8558000000000001 0.6822351658061674 0.6822353143121376 -1.223468856451776e-07 -0.08617796911145716 +0.8559000000000001 0.6822423267725615 0.6822424766434982 -1.0803197247541418e-07 -0.08618187787536508 +0.856 0.6822494859373163 0.682249636876239 -9.370569962682818e-08 -0.08618578561592441 +0.8561 0.6822566433009882 0.682256795010738 -7.937114725187211e-08 -0.08618969233335669 +0.8562000000000001 0.6822637988641015 0.6822639510474056 -6.503139677108138e-08 -0.0861935980278834 +0.8563000000000001 0.6822709526271484 0.6822711049866834 -5.0689530235129704e-08 -0.08619750269972605 +0.8564 0.6822781045905892 0.6822782568290457 -3.634862964573904e-08 -0.08620140634910615 +0.8565 0.682285254754852 0.6822854065749983 -2.201177629859892e-08 -0.08620530897624508 +0.8566 0.682292403120333 0.6822925542250784 -7.682050121027295e-09 -0.08620921058136433 +0.8567 0.6822995496873965 0.6822996997798558 6.637470990368544e-09 -0.08621311116468529 +0.8568000000000001 0.6823066944563745 0.6823068432399318 2.094371182991689e-08 -0.08621701072642933 +0.8569000000000001 0.6823138374275675 0.6823139846059392 3.523360053714342e-08 -0.08622090926681779 +0.857 0.682320978601244 0.682321123878543 4.9504069274397544e-08 -0.08622480678607208 +0.8571 0.6823281179776403 0.6823282610584396 6.37520548713022e-08 -0.08622870328441347 +0.8572000000000001 0.6823352555569613 0.6823353961463571 7.797449949262236e-08 -0.08623259876206328 +0.8573000000000001 0.6823423913393801 0.682342529143055 9.216835127057177e-08 -0.08623649321924277 +0.8574 0.6823495253250382 0.6823496600493248 1.0633056499176341e-07 -0.08624038665617323 +0.8575 0.6823566575140452 0.6823567888659889 1.204581027459961e-07 -0.0862442790730758 +0.8576 0.6823637879064794 0.6823639155939014 1.3454793455075498e-07 -0.08624817047017178 +0.8577 0.682370916502388 0.6823710402339476 1.4859703902081467e-07 -0.08625206084768233 +0.8578000000000001 0.6823780433017863 0.6823781627870437 1.626024040274343e-07 -0.08625595020582864 +0.8579000000000001 0.682385168304659 0.6823852832541374 1.7656102732979684e-07 -0.08625983854483188 +0.858 0.682392291510959 0.6823924016362071 1.9046991722726503e-07 -0.08626372586491311 +0.8581 0.682399412920609 0.6823995179342619 2.0432609318388195e-07 -0.0862676121662935 +0.8582000000000001 0.6824065325334998 0.682406632149342 2.181265864875659e-07 -0.08627149744919407 +0.8583000000000001 0.6824136503494922 0.682413744282518 2.3186844086420244e-07 -0.0862753817138359 +0.8584 0.6824207663684163 0.6824208543348909 2.455487131680645e-07 -0.08627926496044003 +0.8585 0.6824278805900716 0.6824279623075917 2.5916447394386255e-07 -0.08628314718922746 +0.8586 0.6824349930142277 0.6824350682017826 2.727128080651231e-07 -0.0862870284004192 +0.8587 0.6824421036406233 0.6824421720186551 2.861908153933834e-07 -0.08629090859423628 +0.8588000000000001 0.6824492124689673 0.6824492737594303 2.995956113888143e-07 -0.08629478777089956 +0.8589000000000001 0.682456319498939 0.682456373425359 3.1292432772778156e-07 -0.08629866593062992 +0.859 0.682463424730188 0.6824634710177224 3.261741128926521e-07 -0.08630254307364837 +0.8591 0.6824705281623344 0.6824705665378306 3.3934213277547753e-07 -0.0863064192001758 +0.8592000000000001 0.6824776297949686 0.6824776599870221 3.524255713927005e-07 -0.08631029431043297 +0.8593000000000001 0.6824847296276527 0.6824847513666659 3.6542163134312133e-07 -0.08631416840464085 +0.8594 0.682491827659919 0.682491840678158 3.7832753446015444e-07 -0.08631804148302014 +0.8595 0.6824989238912713 0.6824989279229243 3.911405224987785e-07 -0.0863219135457917 +0.8596 0.6825060183211855 0.6825060131024185 4.038578575449314e-07 -0.08632578459317626 +0.8597 0.6825131109491089 0.6825130962181223 4.1647682274409403e-07 -0.08632965462539466 +0.8598000000000001 0.6825202017744605 0.6825201772715459 4.2899472284252393e-07 -0.08633352364266758 +0.8599000000000001 0.6825272907966313 0.6825272562642265 4.4140888476318363e-07 -0.0863373916452157 +0.86 0.6825343780149855 0.6825343331977289 4.5371665814697426e-07 -0.0863412586332597 +0.8601 0.6825414634288592 0.6825414080736454 4.6591541598417496e-07 -0.0863451246070203 +0.8602000000000001 0.6825485470375614 0.6825484808935951 4.780025551209821e-07 -0.08634898956671805 +0.8603000000000001 0.6825556288403751 0.6825555516592239 4.89975496870132e-07 -0.0863528535125737 +0.8604 0.6825627088365557 0.6825626203722037 5.018316874133566e-07 -0.08635671644480775 +0.8605 0.6825697870253324 0.6825696870342333 5.135685985785399e-07 -0.08636057836364075 +0.8606 0.6825768634059093 0.6825767516470367 5.251837282421734e-07 -0.08636443926929332 +0.8607 0.6825839379774634 0.6825838142123641 5.366746008428347e-07 -0.08636829916198598 +0.8608000000000001 0.6825910107391471 0.6825908747319905 5.480387679640542e-07 -0.08637215804193918 +0.8609000000000001 0.6825980816900873 0.6825979332077168 5.592738088339155e-07 -0.08637601590937351 +0.861 0.6826051508293859 0.682604989641368 5.70377330907923e-07 -0.08637987276450937 +0.8611 0.68261221815612 0.6826120440347936 5.813469702575791e-07 -0.08638372860756723 +0.8612000000000001 0.6826192836693428 0.6826190963898675 5.921803921810076e-07 -0.08638758343876744 +0.8613000000000001 0.6826263473680829 0.6826261467084873 6.028752916609204e-07 -0.08639143725833043 +0.8614 0.6826334092513457 0.6826331949925746 6.134293938225843e-07 -0.08639529006647656 +0.8615 0.6826404693181132 0.6826402412440737 6.238404544611775e-07 -0.08639914186342623 +0.8616 0.682647527567344 0.6826472854649523 6.341062605275116e-07 -0.08640299264939978 +0.8617 0.6826545839979741 0.6826543276572006 6.442246305859989e-07 -0.08640684242461746 +0.8618000000000001 0.6826616386089168 0.6826613678228305 6.541934152726192e-07 -0.0864106911892996 +0.8619000000000001 0.6826686913990643 0.6826684059638763 6.640104977390093e-07 -0.08641453894366642 +0.862 0.6826757423672856 0.6826754420823941 6.73673794165941e-07 -0.08641838568793819 +0.8621 0.6826827915124294 0.6826824761804609 6.831812540686322e-07 -0.08642223142233511 +0.8622000000000001 0.6826898388333229 0.6826895082601745 6.925308609490033e-07 -0.08642607614707737 +0.8623000000000001 0.6826968843287726 0.6826965383236534 7.017206325038439e-07 -0.08642991986238513 +0.8624 0.682703927997565 0.6827035663730364 7.107486212076797e-07 -0.08643376256847857 +0.8625 0.6827109698384664 0.6827105924104819 7.196129146319619e-07 -0.0864376042655778 +0.8626 0.6827180098502236 0.6827176164381683 7.283116359446673e-07 -0.08644144495390296 +0.8627 0.6827250480315641 0.6827246384582923 7.368429441600988e-07 -0.08644528463367412 +0.8628000000000001 0.6827320843811961 0.6827316584730698 7.452050346662409e-07 -0.08644912330511134 +0.8629000000000001 0.6827391188978105 0.6827386764847344 7.533961395161937e-07 -0.08645296096843465 +0.863 0.6827461515800789 0.6827456924955384 7.614145279555284e-07 -0.08645679762386405 +0.8631 0.6827531824266557 0.6827527065077512 7.692585065749435e-07 -0.08646063327161953 +0.8632000000000001 0.6827602114361782 0.6827597185236596 7.769264198237424e-07 -0.08646446791192107 +0.8633000000000001 0.6827672386072663 0.682766728545567 7.844166502873895e-07 -0.08646830154498862 +0.8634000000000001 0.6827742639385241 0.6827737365757931 7.91727619076088e-07 -0.08647213417104213 +0.8635 0.6827812874285386 0.6827807426166737 7.98857786171725e-07 -0.08647596579030145 +0.8636 0.682788309075882 0.6827877466705603 8.0580565062216e-07 -0.08647979640298653 +0.8637 0.6827953288791108 0.682794748739819 8.125697510685814e-07 -0.08648362600931717 +0.8638000000000001 0.6828023468367665 0.6828017488268313 8.19148665814895e-07 -0.08648745460951324 +0.8639000000000001 0.6828093629473765 0.6828087469339926 8.255410134105912e-07 -0.08649128220379454 +0.864 0.6828163772094539 0.6828157430637122 8.317454526923784e-07 -0.08649510879238083 +0.8641 0.6828233896214979 0.682822737218413 8.377606832143947e-07 -0.0864989343754919 +0.8642000000000001 0.6828304001819951 0.682829729400531 8.43585445331474e-07 -0.0865027589533475 +0.8643000000000001 0.6828374088894194 0.6828367196125145 8.492185208514025e-07 -0.08650658252616733 +0.8644000000000001 0.6828444157422313 0.6828437078568244 8.546587328267519e-07 -0.08651040509417113 +0.8645 0.6828514207388805 0.6828506941359334 8.59904946082235e-07 -0.08651422665757852 +0.8646 0.6828584238778047 0.6828576784523249 8.649560674089951e-07 -0.08651804721660923 +0.8647 0.6828654251574306 0.6828646608084938 8.698110457033836e-07 -0.08652186677148281 +0.8648 0.6828724245761744 0.6828716412069455 8.74468872438805e-07 -0.08652568532241892 +0.8649000000000001 0.6828794221324422 0.6828786196501949 8.789285815546943e-07 -0.08652950286963713 +0.865 0.6828864178246299 0.6828855961407668 8.831892497895844e-07 -0.08653331941335697 +0.8651 0.6828934116511246 0.682892570681195 8.872499969447833e-07 -0.086537134953798 +0.8652000000000001 0.682900403610305 0.6828995432740224 8.911099858566196e-07 -0.0865409494911798 +0.8653000000000001 0.6829073937005402 0.6829065139217991 8.947684230209418e-07 -0.08654476302572178 +0.8654000000000001 0.6829143819201924 0.6829134826270842 8.982245582045412e-07 -0.08654857555764342 +0.8655 0.682921368267616 0.682920449392443 9.014776848892403e-07 -0.0865523870871642 +0.8656 0.682928352741158 0.6829274142204488 9.045271404939381e-07 -0.0865561976145035 +0.8657 0.68293533533916 0.6829343771136803 9.07372306291343e-07 -0.0865600071398808 +0.8658 0.6829423160599559 0.6829413380747227 9.100126076855286e-07 -0.08656381566351538 +0.8659000000000001 0.6829492949018754 0.6829482971061664 9.124475142674449e-07 -0.08656762318562666 +0.866 0.682956271863242 0.6829552542106074 9.146765399259404e-07 -0.08657142970643397 +0.8661 0.6829632469423752 0.6829622093906456 9.166992430698073e-07 -0.08657523522615665 +0.8662000000000001 0.6829702201375896 0.6829691626488852 9.185152265167584e-07 -0.08657903974501392 +0.8663000000000001 0.6829771914471962 0.6829761139879341 9.201241376599611e-07 -0.08658284326322507 +0.8664000000000001 0.6829841608695031 0.6829830634104035 9.21525668551304e-07 -0.08658664578100936 +0.8665 0.682991128402815 0.6829900109189071 9.227195558736412e-07 -0.08659044729858599 +0.8666 0.6829980940454347 0.6829969565160612 9.237055812738593e-07 -0.08659424781617416 +0.8667 0.6830050577956621 0.6830039002044832 9.244835709742993e-07 -0.08659804733399301 +0.8668 0.683012019651797 0.6830108419867926 9.250533961335794e-07 -0.08660184585226177 +0.8669000000000001 0.683018979612137 0.6830177818656096 9.25414972735572e-07 -0.0866056433711995 +0.867 0.6830259376749797 0.6830247198435544 9.255682617004268e-07 -0.08660943989102532 +0.8671 0.6830328938386224 0.6830316559232474 9.25513268829059e-07 -0.08661323541195833 +0.8672000000000001 0.6830398481013631 0.6830385901073085 9.252500445811052e-07 -0.08661702993421753 +0.8673000000000001 0.6830468004615005 0.6830455223983563 9.247786844357453e-07 -0.08662082345802201 +0.8674000000000001 0.6830537509173343 0.6830524527990083 9.240993286141475e-07 -0.08662461598359077 +0.8675 0.6830606994671665 0.68305938131188 9.232121622737566e-07 -0.08662840751114281 +0.8676 0.683067646109301 0.6830663079395844 9.22117414953183e-07 -0.08663219804089707 +0.8677 0.6830745908420446 0.6830732326847317 9.20815361127314e-07 -0.08663598757307248 +0.8678 0.6830815336637069 0.6830801555499285 9.193063198742468e-07 -0.08663977610788798 +0.8679000000000001 0.6830884745726018 0.683087076537778 9.175906547087553e-07 -0.08664356364556247 +0.868 0.6830954135670464 0.683093995650879 9.156687736933122e-07 -0.08664735018631481 +0.8681 0.6831023506453634 0.6831009128918257 9.135411291327777e-07 -0.08665113573036384 +0.8682000000000001 0.6831092858058795 0.6831078282632068 9.112082176021552e-07 -0.0866549202779284 +0.8683000000000001 0.6831162190469278 0.6831147417676058 9.086705798910799e-07 -0.0866587038292273 +0.8684000000000001 0.6831231503668465 0.6831216534075997 9.059288007540189e-07 -0.08666248638447933 +0.8685 0.6831300797639805 0.6831285631857593 9.029835087992488e-07 -0.08666626794390318 +0.8686 0.683137007236682 0.6831354711046485 8.998353764333444e-07 -0.08667004850771766 +0.8687 0.68314393278331 0.6831423771668232 8.964851195836232e-07 -0.08667382807614146 +0.8688 0.6831508564022313 0.683149281374832 8.929334976981451e-07 -0.08667760664939328 +0.8689000000000001 0.6831577780918205 0.6831561837312146 8.891813133848903e-07 -0.0866813842276917 +0.869 0.6831646978504617 0.6831630842385024 8.852294123840032e-07 -0.0866851608112554 +0.8691 0.6831716156765477 0.6831699828992172 8.810786832902373e-07 -0.08668893640030305 +0.8692000000000001 0.6831785315684806 0.6831768797158713 8.767300574558101e-07 -0.08669271099505318 +0.8693000000000001 0.6831854455246728 0.6831837746909672 8.72184508560192e-07 -0.08669648459572442 +0.8694000000000001 0.6831923575435468 0.6831906678269961 8.67443052693373e-07 -0.08670025720253527 +0.8695 0.6831992676235364 0.6831975591264385 8.625067480366733e-07 -0.08670402881570426 +0.8696 0.6832061757630863 0.6832044485917639 8.573766944047767e-07 -0.0867077994354499 +0.8697 0.6832130819606528 0.6832113362254293 8.520540332734861e-07 -0.08671156906199064 +0.8698 0.6832199862147044 0.6832182220298797 8.465399474466562e-07 -0.08671533769554494 +0.8699000000000001 0.6832268885237227 0.6832251060075474 8.408356607786382e-07 -0.08671910533633123 +0.87 0.6832337888862019 0.6832319881608516 8.349424377857018e-07 -0.08672287198456793 +0.8701 0.6832406873006497 0.6832388684921977 8.288615837709346e-07 -0.08672663764047345 +0.8702000000000001 0.6832475837655876 0.6832457470039776 8.225944439360644e-07 -0.08673040230426614 +0.8703000000000001 0.6832544782795511 0.6832526236985679 8.161424036173814e-07 -0.08673416597616428 +0.8704000000000001 0.6832613708410906 0.6832594985783312 8.095068876196043e-07 -0.08673792865638624 +0.8705 0.6832682614487717 0.6832663716456147 8.026893601603691e-07 -0.08674169034515028 +0.8706 0.6832751501011751 0.6832732429027499 7.956913243706287e-07 -0.08674545104267467 +0.8707 0.6832820367968977 0.683280112352052 7.885143220309754e-07 -0.08674921074917762 +0.8708 0.6832889215345526 0.68328697999582 7.811599332802066e-07 -0.08675296946487736 +0.8709000000000001 0.6832958043127695 0.6832938458363362 7.736297762683808e-07 -0.08675672718999207 +0.871 0.6833026851301951 0.6833007098758661 7.65925506643339e-07 -0.08676048392474002 +0.8711 0.683309563985494 0.6833075721166562 7.580488174258049e-07 -0.08676423966933926 +0.8712000000000001 0.6833164408773482 0.6833144325609364 7.500014384126397e-07 -0.08676799442400794 +0.8713000000000001 0.6833233158044577 0.6833212912109177 7.4178513594092e-07 -0.08677174818896416 +0.8714000000000001 0.6833301887655416 0.6833281480687922 7.334017124716041e-07 -0.08677550096442599 +0.8715 0.6833370597593376 0.6833350031367333 7.248530061731984e-07 -0.08677925275061146 +0.8716 0.6833439287846029 0.6833418564168945 7.16140890533179e-07 -0.08678300354773866 +0.8717 0.6833507958401146 0.68334870791141 7.072672739832919e-07 -0.08678675335602555 +0.8718 0.6833576609246694 0.683355557622393 6.982340993860747e-07 -0.08679050217569012 +0.8719000000000001 0.6833645240370846 0.683362405551937 6.890433437711785e-07 -0.08679425000695035 +0.872 0.6833713851761983 0.6833692517021137 6.796970176831119e-07 -0.08679799685002415 +0.8721 0.6833782443408698 0.6833760960749745 6.701971649591965e-07 -0.08680174270512946 +0.8722000000000001 0.6833851015299794 0.6833829386725487 6.605458621605775e-07 -0.08680548757248414 +0.8723000000000001 0.6833919567424296 0.6833897794968433 6.507452181558904e-07 -0.08680923145230597 +0.8724000000000001 0.6833988099771449 0.6833966185498437 6.40797373677171e-07 -0.08681297434481294 +0.8725 0.6834056612330723 0.6834034558335127 6.307045007786227e-07 -0.0868167162502228 +0.8726 0.6834125105091815 0.6834102913497896 6.204688025174265e-07 -0.08682045716875333 +0.8727 0.6834193578044649 0.6834171251005909 6.100925122320966e-07 -0.08682419710062232 +0.8728 0.6834262031179391 0.6834239570878093 5.995778933343132e-07 -0.08682793604604745 +0.8729000000000001 0.6834330464486436 0.6834307873133143 5.889272385595223e-07 -0.08683167400524651 +0.873 0.6834398877956422 0.6834376157789505 5.781428696893798e-07 -0.08683541097843717 +0.8731 0.6834467271580233 0.6834444424865382 5.672271368994952e-07 -0.08683914696583715 +0.8732000000000001 0.6834535645348996 0.6834512674378732 5.56182418315343e-07 -0.086842881967664 +0.8733000000000001 0.6834603999254083 0.6834580906347265 5.450111194432727e-07 -0.08684661598413547 +0.8734000000000001 0.6834672333287124 0.6834649120788432 5.337156727264203e-07 -0.08685034901546908 +0.8735 0.6834740647439999 0.6834717317719432 5.222985369618405e-07 -0.08685408106188242 +0.8736 0.6834808941704845 0.6834785497157204 5.107621966760068e-07 -0.08685781212359306 +0.8737 0.6834877216074062 0.6834853659118426 4.991091618472554e-07 -0.08686154220081849 +0.8738 0.6834945470540306 0.6834921803619514 4.873419670592405e-07 -0.08686527129377619 +0.8739000000000001 0.6835013705096504 0.6834989930676619 4.7546317115398917e-07 -0.08686899940268378 +0.874 0.6835081919735848 0.6835058040305617 4.634753566351568e-07 -0.08687272652775857 +0.8741 0.6835150114451798 0.6835126132522118 4.513811290296488e-07 -0.08687645266921805 +0.8742000000000001 0.6835218289238086 0.6835194207341457 4.391831163463866e-07 -0.08688017782727961 +0.8743000000000001 0.6835286444088722 0.6835262264778701 4.268839686044634e-07 -0.08688390200216072 +0.8744000000000001 0.6835354578997985 0.6835330304848619 4.1448635718088767e-07 -0.08688762519407858 +0.8745 0.6835422693960442 0.6835398327565723 4.019929741999606e-07 -0.08689134740325066 +0.8746 0.6835490788970934 0.6835466332944229 3.8940653199898145e-07 -0.0868950686298943 +0.8747 0.6835558864024585 0.6835534320998076 3.7672976253844137e-07 -0.0868987888742267 +0.8748 0.6835626919116804 0.6835602291740908 3.639654168052786e-07 -0.0869025081364651 +0.8749000000000001 0.683569495424329 0.6835670245186087 3.511162642230725e-07 -0.08690622641682683 +0.875 0.6835762969400028 0.683573818134669 3.381850919997875e-07 -0.08690994371552908 +0.8751 0.6835830964583292 0.6835806100235489 3.251747045726616e-07 -0.08691366003278901 +0.8752000000000001 0.683589893978965 0.6835874001864974 3.1208792303921706e-07 -0.08691737536882382 +0.8753000000000001 0.6835966895015961 0.6835941886247334 2.9892758447030987e-07 -0.08692108972385065 +0.8754000000000001 0.6836034830259388 0.6836009753394459 2.8569654129950717e-07 -0.08692480309808659 +0.8755 0.6836102745517378 0.6836077603317953 2.72397660747159e-07 -0.08692851549174886 +0.8756 0.6836170640787685 0.6836145436029103 2.590338241958978e-07 -0.0869322269050544 +0.8757 0.6836238516068358 0.6836213251538905 2.456079265383826e-07 -0.08693593733822023 +0.8758 0.6836306371357751 0.6836281049858051 2.3212287559443157e-07 -0.08693964679146345 +0.8759000000000001 0.6836374206654522 0.6836348830996929 2.1858159143794964e-07 -0.0869433552650011 +0.876 0.6836442021957625 0.683641659496562 2.0498700573079454e-07 -0.08694706275905008 +0.8761 0.6836509817266325 0.6836484341773902 1.9134206120235975e-07 -0.08695076927382739 +0.8762000000000001 0.6836577592580191 0.6836552071431241 1.776497109209907e-07 -0.08695447480954993 +0.8763000000000001 0.6836645347899097 0.6836619783946799 1.639129176972398e-07 -0.08695817936643459 +0.8764000000000001 0.6836713083223229 0.6836687479329426 1.5013465340038556e-07 -0.08696188294469825 +0.8765 0.6836780798553078 0.6836755157587664 1.363178983686264e-07 -0.0869655855445578 +0.8766 0.6836848493889447 0.683682281872974 1.2246564073253863e-07 -0.08696928716623005 +0.8767 0.6836916169233448 0.6836890462763575 1.0858087577322872e-07 -0.08697298780993185 +0.8768 0.6836983824586502 0.6836958089696771 9.46666052839551e-08 -0.08697668747587989 +0.8769000000000001 0.683705145995035 0.683702569953662 8.072583690746371e-08 -0.08698038616429099 +0.877 0.683711907532703 0.68370932922901 6.676158348720151e-08 -0.08698408387538184 +0.8771 0.6837186670718908 0.6837160867963878 5.2776862442815986e-08 -0.08698778060936924 +0.8772000000000001 0.6837254246128653 0.6837228426564304 3.8774695078000465e-08 -0.08699147636646977 +0.8773000000000001 0.6837321801559255 0.6837295968097408 2.4758105957728427e-08 -0.08699517114690014 +0.8774000000000001 0.683738933701401 0.6837363492568912 1.073012224385439e-08 -0.086998864950877 +0.8775 0.6837456852496534 0.6837430999984218 -3.306226964081005e-09 -0.08700255777861687 +0.8776 0.6837524348010755 0.6837498490348417 -1.7347911263759785e-08 -0.0870062496303365 +0.8777 0.6837591823560912 0.6837565963666281 -3.13918996335677e-08 -0.08700994050625233 +0.8778 0.6837659279151564 0.6837633419942266 -4.543516105882939e-08 -0.08701363040658094 +0.8779000000000001 0.683772671478758 0.6837700859180513 -5.947466520162849e-08 -0.08701731933153885 +0.878 0.6837794130474143 0.6837768281384848 -7.350738305154578e-08 -0.0870210072813425 +0.8781 0.6837861526216751 0.683783568655878 -8.753028757878256e-08 -0.08702469425620837 +0.8782000000000001 0.6837928902021212 0.6837903074705507 -1.0154035438858511e-07 -0.0870283802563529 +0.8783000000000001 0.6837996257893656 0.6837970445827908 -1.1553456237198279e-07 -0.08703206528199255 +0.8784000000000001 0.6838063593840517 0.6838037799928551 -1.2950989435565885e-07 -0.08703574933334368 +0.8785 0.6838130909868545 0.6838105137009687 -1.4346333776678322e-07 -0.08703943241062266 +0.8786 0.6838198205984802 0.6838172457073259 -1.5739188525057402e-07 -0.08704311451404587 +0.8787 0.6838265482196659 0.683823976012089 -1.7129253535377864e-07 -0.08704679564382958 +0.8788 0.6838332738511799 0.6838307046153893 -1.8516229315784782e-07 -0.08705047580019007 +0.8789000000000001 0.6838399974938214 0.6838374315173275 -1.989981709277222e-07 -0.08705415498334362 +0.879 0.6838467191484208 0.6838441567179725 -2.1279718874153697e-07 -0.08705783319350649 +0.8791 0.6838534388158388 0.683850880217363 -2.2655637514981675e-07 -0.08706151043089494 +0.8792000000000001 0.6838601564969671 0.683857602015506 -2.4027276780344553e-07 -0.08706518669572509 +0.8793000000000001 0.6838668721927281 0.6838643221123786 -2.5394341410939214e-07 -0.08706886198821313 +0.8794000000000001 0.6838735859040745 0.6838710405079265 -2.675653718482718e-07 -0.08707253630857525 +0.8795 0.6838802976319898 0.6838777572020652 -2.8113570981619374e-07 -0.08707620965702755 +0.8796 0.683887007377487 0.68388447219468 -2.946515084492618e-07 -0.0870798820337861 +0.8797 0.6838937151416098 0.6838911854856251 -3.081098604792998e-07 -0.08708355343906694 +0.8798 0.683900420925432 0.6838978970747254 -3.215078715340658e-07 -0.0870872238730862 +0.8799000000000001 0.6839071247300572 0.6839046069617754 -3.348426607235888e-07 -0.0870908933360599 +0.88 0.6839138265566187 0.6839113151465395 -3.4811136134793585e-07 -0.08709456182820399 +0.8801 0.6839205264062791 0.6839180216287528 -3.6131112145232347e-07 -0.08709822934973448 +0.8802000000000001 0.6839272242802307 0.6839247264081207 -3.74439104465496e-07 -0.0871018959008673 +0.8803000000000001 0.6839339201796948 0.6839314294843188 -3.874924898172871e-07 -0.08710556148181833 +0.8804000000000001 0.6839406141059223 0.6839381308569941 -4.004684734590369e-07 -0.08710922609280357 +0.8805 0.6839473060601926 0.6839448305257639 -4.1336426861299236e-07 -0.0871128897340388 +0.8806 0.6839539960438138 0.6839515284902171 -4.261771062372133e-07 -0.08711655240573991 +0.8807 0.6839606840581229 0.6839582247499139 -4.3890423576109505e-07 -0.08712021410812278 +0.8808 0.6839673701044846 0.6839649193043853 -4.515429254808856e-07 -0.08712387484140306 +0.8809000000000001 0.6839740541842924 0.683971612153135 -4.6409046336459703e-07 -0.08712753460579666 +0.881 0.6839807362989672 0.6839783032956381 -4.7654415744752265e-07 -0.0871311934015193 +0.8811 0.683987416449958 0.6839849927313422 -4.889013365538819e-07 -0.08713485122878668 +0.8812000000000001 0.6839940946387411 0.6839916804596664 -5.011593507894818e-07 -0.08713850808781452 +0.8813000000000001 0.6840007708668202 0.6839983664800032 -5.133155721662175e-07 -0.08714216397881848 +0.8814000000000001 0.6840074451357259 0.6840050507917177 -5.253673950461613e-07 -0.08714581890201424 +0.8815 0.6840141174470155 0.6840117333941482 -5.373122368285133e-07 -0.08714947285761744 +0.8816 0.6840207878022728 0.6840184142866058 -5.491475385394073e-07 -0.08715312584584359 +0.8817 0.6840274562031083 0.6840250934683756 -5.608707651927336e-07 -0.08715677786690836 +0.8818 0.6840341226511587 0.6840317709387165 -5.724794065048444e-07 -0.08716042892102728 +0.8819000000000001 0.6840407871480856 0.6840384466968609 -5.839709773386437e-07 -0.08716407900841587 +0.882 0.6840474496955766 0.6840451207420163 -5.953430183280872e-07 -0.08716772812928962 +0.8821 0.684054110295345 0.6840517930733644 -6.065930963083943e-07 -0.08717137628386404 +0.8822000000000001 0.684060768949128 0.6840584636900617 -6.177188048850368e-07 -0.08717502347235455 +0.8823000000000001 0.6840674256586885 0.6840651325912399 -6.287177649749731e-07 -0.08717866969497653 +0.8824000000000001 0.6840740804258135 0.6840717997760066 -6.395876251674704e-07 -0.08718231495194552 +0.8825 0.684080733252314 0.6840784652434444 -6.50326062487383e-07 -0.0871859592434768 +0.8826 0.6840873841400248 0.6840851289926125 -6.609307826727084e-07 -0.08718960256978578 +0.8827 0.6840940330908039 0.6840917910225459 -6.713995207852097e-07 -0.08719324493108768 +0.8828 0.6841006801065332 0.6840984513322571 -6.817300416406269e-07 -0.0871968863275979 +0.8829000000000001 0.684107325189117 0.6841051099207346 -6.919201402666442e-07 -0.08720052675953167 +0.883 0.6841139683404823 0.684111766786945 -7.019676424857568e-07 -0.0872041662271043 +0.8831 0.6841206095625784 0.684118421929832 -7.118704051928271e-07 -0.08720780473053097 +0.8832000000000001 0.684127248857376 0.6841250753483171 -7.216263170628512e-07 -0.08721144227002685 +0.8833000000000001 0.6841338862268683 0.684131727041301 -7.312332987036152e-07 -0.08721507884580719 +0.8834000000000001 0.6841405216730689 0.6841383770076617 -7.406893033634621e-07 -0.0872187144580871 +0.8835 0.6841471551980132 0.684145025246257 -7.499923172643586e-07 -0.08722234910708175 +0.8836 0.6841537868037558 0.684151671755924 -7.591403600459845e-07 -0.0872259827930062 +0.8837 0.6841604164923727 0.6841583165354788 -7.681314850571663e-07 -0.0872296155160755 +0.8838 0.6841670442659592 0.6841649595837183 -7.769637800358886e-07 -0.08723324727650475 +0.8839000000000001 0.6841736701266303 0.6841716008994193 -7.856353672897054e-07 -0.087236878074509 +0.884 0.6841802940765201 0.6841782404813394 -7.941444041537071e-07 -0.08724050791030319 +0.8841 0.6841869161177814 0.6841848783282172 -8.02489083490121e-07 -0.08724413678410231 +0.8842000000000001 0.6841935362525853 0.6841915144387729 -8.10667633896478e-07 -0.08724776469612135 +0.8843000000000001 0.6842001544831211 0.6841981488117088 -8.186783202746017e-07 -0.08725139164657525 +0.8844000000000001 0.6842067708115954 0.6842047814457088 -8.265194441081647e-07 -0.08725501763567883 +0.8845 0.6842133852402323 0.6842114123394398 -8.341893436986103e-07 -0.08725864266364704 +0.8846 0.6842199977712728 0.6842180414915515 -8.41686394761898e-07 -0.08726226673069468 +0.8847 0.6842266084069744 0.6842246689006772 -8.490090105256476e-07 -0.08726588983703659 +0.8848 0.6842332171496104 0.6842312945654339 -8.56155642339762e-07 -0.08726951198288757 +0.8849000000000001 0.68423982400147 0.6842379184844225 -8.631247797180608e-07 -0.08727313316846246 +0.885 0.6842464289648573 0.684244540656229 -8.699149508517579e-07 -0.08727675339397589 +0.8851 0.6842530320420919 0.6842511610794239 -8.765247228870177e-07 -0.08728037265964267 +0.8852000000000001 0.6842596332355073 0.6842577797525631 -8.82952702188633e-07 -0.08728399096567743 +0.8853000000000001 0.6842662325474516 0.6842643966741888 -8.891975347563585e-07 -0.08728760831229494 +0.8854000000000001 0.6842728299802859 0.6842710118428288 -8.952579061693999e-07 -0.08729122469970978 +0.8855 0.6842794255363851 0.6842776252569979 -9.011325423913252e-07 -0.0872948401281366 +0.8856 0.6842860192181363 0.6842842369151978 -9.068202094647537e-07 -0.08729845459778995 +0.8857 0.6842926110279397 0.6842908468159177 -9.123197143440231e-07 -0.08730206810888451 +0.8858 0.6842992009682067 0.6842974549576346 -9.176299046592673e-07 -0.0873056806616347 +0.8859000000000001 0.6843057890413611 0.684304061338814 -9.227496692854054e-07 -0.08730929225625517 +0.886 0.6843123752498368 0.6843106659579101 -9.276779383698974e-07 -0.0873129028929603 +0.8861 0.684318959596079 0.6843172688133659 -9.324136836519337e-07 -0.0873165125719646 +0.8862000000000001 0.6843255420825431 0.6843238699036146 -9.369559187955012e-07 -0.08732012129348257 +0.8863000000000001 0.6843321227116941 0.6843304692270793 -9.413036992783619e-07 -0.08732372905772856 +0.8864000000000001 0.6843387014860065 0.6843370667821731 -9.454561229055303e-07 -0.08732733586491698 +0.8865 0.6843452784079638 0.6843436625673007 -9.49412329864785e-07 -0.08733094171526226 +0.8866 0.6843518534800572 0.6843502565808577 -9.531715028515686e-07 -0.08733454660897864 +0.8867 0.6843584267047874 0.6843568488212317 -9.567328673465436e-07 -0.08733815054628052 +0.8868 0.6843649980846616 0.6843634392868028 -9.600956917543702e-07 -0.08734175352738219 +0.8869000000000001 0.684371567622194 0.684370027975943 -9.632592875286061e-07 -0.08734535555249785 +0.887 0.6843781353199063 0.6843766148870185 -9.662230091994628e-07 -0.08734895662184183 +0.8871 0.684384701180326 0.6843832000183885 -9.689862548040162e-07 -0.08735255673562833 +0.8872000000000001 0.6843912652059861 0.6843897833684064 -9.715484657335516e-07 -0.08735615589407149 +0.8873000000000001 0.6843978273994255 0.68439636493542 -9.739091269139744e-07 -0.08735975409738553 +0.8874000000000001 0.6844043877631873 0.6844029447177719 -9.76067766958466e-07 -0.08736335134578449 +0.8875 0.68441094629982 0.6844095227138007 -9.780239583340178e-07 -0.08736694763948262 +0.8876000000000001 0.684417503011875 0.6844160989218406 -9.797773173475521e-07 -0.08737054297869393 +0.8877 0.684424057901908 0.6844226733402221 -9.813275041042901e-07 -0.08737413736363253 +0.8878 0.6844306109724774 0.6844292459672722 -9.82674222840818e-07 -0.08737773079451241 +0.8879000000000001 0.6844371622261441 0.6844358168013156 -9.838172217169205e-07 -0.08738132327154763 +0.888 0.6844437116654715 0.6844423858406745 -9.847562931764031e-07 -0.08738491479495213 +0.8881 0.6844502592930244 0.6844489530836695 -9.85491273503003e-07 -0.0873885053649399 +0.8882000000000001 0.6844568051113689 0.6844555185286192 -9.860220435142786e-07 -0.08739209498172489 +0.8883000000000001 0.6844633491230716 0.6844620821738421 -9.863485279371087e-07 -0.08739568364552097 +0.8884000000000001 0.6844698913306999 0.6844686440176556 -9.864706958795377e-07 -0.08739927135654205 +0.8885 0.684476431736821 0.6844752040583775 -9.86388560469953e-07 -0.08740285811500204 +0.8886000000000001 0.684482970344001 0.6844817622943256 -9.861021791068847e-07 -0.08740644392111467 +0.8887 0.6844895071548049 0.6844883187238194 -9.856116533479842e-07 -0.0874100287750938 +0.8888 0.6844960421717972 0.684494873345179 -9.849171288545122e-07 -0.08741361267715322 +0.8889000000000001 0.6845025753975389 0.684501426156727 -9.840187955023616e-07 -0.08741719562750669 +0.889 0.6845091068345894 0.6845079771567877 -9.829168869379679e-07 -0.08742077762636791 +0.8891 0.6845156364855054 0.6845145263436884 -9.816116812166875e-07 -0.0874243586739506 +0.8892 0.68452216435284 0.68452107371576 -9.801034999978864e-07 -0.08742793877046849 +0.8893000000000001 0.6845286904391418 0.6845276192713363 -9.78392708905762e-07 -0.08743151791613513 +0.8894000000000001 0.6845352147469561 0.6845341630087558 -9.764797172656658e-07 -0.08743509611116425 +0.8895 0.6845417372788232 0.6845407049263615 -9.743649781457364e-07 -0.08743867335576941 +0.8896000000000001 0.6845482580372777 0.6845472450225013 -9.720489881487326e-07 -0.08744224965016416 +0.8897 0.6845547770248492 0.6845537832955287 -9.695322873426448e-07 -0.08744582499456212 +0.8898 0.6845612942440606 0.6845603197438029 -9.668154590247724e-07 -0.08744939938917673 +0.8899000000000001 0.684567809697429 0.6845668543656896 -9.638991298743793e-07 -0.08745297283422154 +0.89 0.6845743233874637 0.6845733871595617 -9.607839693420717e-07 -0.08745654532991 +0.8901 0.6845808353166674 0.6845799181237988 -9.574706901355201e-07 -0.08746011687645557 +0.8902 0.6845873454875342 0.6845864472567887 -9.53960047359037e-07 -0.08746368747407168 +0.8903000000000001 0.6845938539025505 0.6845929745569271 -9.502528388605214e-07 -0.08746725712297175 +0.8904000000000001 0.684600360564193 0.6845995000226184 -9.463499049122692e-07 -0.0874708258233691 +0.8905 0.6846068654749302 0.684606023652276 -9.422521278223961e-07 -0.08747439357547708 +0.8906000000000001 0.6846133686372207 0.6846125454443229 -9.379604321013701e-07 -0.08747796037950907 +0.8907 0.6846198700535124 0.6846190653971919 -9.334757838652674e-07 -0.0874815262356783 +0.8908 0.6846263697262436 0.6846255835093262 -9.287991909190385e-07 -0.08748509114419806 +0.8909000000000001 0.6846328676578408 0.6846320997791795 -9.239317023818083e-07 -0.08748865510528156 +0.891 0.6846393638507197 0.6846386142052173 -9.188744085897316e-07 -0.08749221811914203 +0.8911 0.6846458583072841 0.6846451267859164 -9.13628440554759e-07 -0.08749578018599266 +0.8912 0.6846523510299256 0.6846516375197655 -9.081949701172931e-07 -0.08749934130604664 +0.8913000000000001 0.6846588420210231 0.6846581464052665 -9.025752094188322e-07 -0.08750290147951711 +0.8914000000000001 0.6846653312829423 0.6846646534409331 -8.967704106938035e-07 -0.08750646070661715 +0.8915 0.6846718188180357 0.6846711586252933 -8.907818659642519e-07 -0.08751001898755988 +0.8916000000000001 0.6846783046286418 0.6846776619568882 -8.84610906845551e-07 -0.08751357632255832 +0.8917 0.6846847887170847 0.6846841634342731 -8.782589041023137e-07 -0.08751713271182554 +0.8918 0.6846912710856741 0.6846906630560183 -8.717272675512477e-07 -0.08752068815557452 +0.8919000000000001 0.6846977517367039 0.6846971608207086 -8.650174455754334e-07 -0.08752424265401826 +0.892 0.6847042306724533 0.6847036567269442 -8.581309249161562e-07 -0.0875277962073697 +0.8921 0.6847107078951855 0.6847101507733413 -8.510692302843292e-07 -0.08753134881584175 +0.8922 0.684717183407147 0.684716642958532 -8.438339239025261e-07 -0.08753490047964738 +0.8923000000000001 0.6847236572105677 0.6847231332811647 -8.364266055049807e-07 -0.08753845119899939 +0.8924000000000001 0.6847301293076609 0.6847296217399055 -8.28848911588187e-07 -0.08754200097411069 +0.8925 0.6847365997006218 0.6847361083334369 -8.21102515452532e-07 -0.08754554980519408 +0.8926000000000001 0.6847430683916282 0.6847425930604594 -8.131891263835067e-07 -0.08754909769246234 +0.8927 0.68474953538284 0.6847490759196918 -8.051104896100725e-07 -0.0875526446361283 +0.8928 0.6847560006763977 0.6847555569098709 -7.968683858605718e-07 -0.08755619063640466 +0.8929000000000001 0.6847624642744236 0.6847620360297524 -7.884646308908838e-07 -0.08755973569350416 +0.893 0.6847689261790202 0.6847685132781112 -7.799010751652347e-07 -0.08756327980763946 +0.8931 0.6847753863922706 0.6847749886537418 -7.711796032872087e-07 -0.08756682297902328 +0.8932 0.6847818449162382 0.6847814621554582 -7.623021338470926e-07 -0.08757036520786823 +0.8933000000000001 0.6847883017529655 0.684787933782095 -7.532706188667637e-07 -0.08757390649438695 +0.8934000000000001 0.6847947569044748 0.6847944035325071 -7.440870433278457e-07 -0.08757744683879208 +0.8935 0.6848012103727666 0.6848008714055702 -7.347534247276188e-07 -0.08758098624129605 +0.8936000000000001 0.684807662159821 0.6848073374001812 -7.252718128153424e-07 -0.08758452470211145 +0.8937 0.6848141122675961 0.6848138015152592 -7.156442888844872e-07 -0.08758806222145091 +0.8938 0.6848205606980275 0.6848202637497441 -7.058729655229357e-07 -0.08759159879952678 +0.8939000000000001 0.6848270074530289 0.6848267241025987 -6.959599860995036e-07 -0.08759513443655155 +0.894 0.6848334525344912 0.684833182572808 -6.859075242088286e-07 -0.08759866913273767 +0.8941 0.6848398959442823 0.6848396391593801 -6.757177833383032e-07 -0.08760220288829754 +0.8942 0.6848463376842469 0.6848460938613461 -6.653929962574523e-07 -0.08760573570344352 +0.8943000000000001 0.6848527777562061 0.6848525466777602 -6.549354245183325e-07 -0.08760926757838798 +0.8944000000000001 0.6848592161619573 0.6848589976077011 -6.443473581363435e-07 -0.0876127985133433 +0.8945 0.6848656529032736 0.6848654466502705 -6.336311149518492e-07 -0.08761632850852175 +0.8946000000000001 0.6848720879819035 0.6848718938045951 -6.227890401028224e-07 -0.08761985756413558 +0.8947 0.6848785213995706 0.684878339069826 -6.118235056223886e-07 -0.08762338568039703 +0.8948 0.684884953157974 0.684884782445139 -6.0073690978657e-07 -0.08762691285751834 +0.8949000000000001 0.6848913832587875 0.6848912239297351 -5.895316767118297e-07 -0.08763043909571173 +0.895 0.684897811703659 0.6848976635228409 -5.782102557860824e-07 -0.08763396439518935 +0.8951 0.6849042384942107 0.6849041012237083 -5.667751210580718e-07 -0.08763748875616333 +0.8952 0.684910663632039 0.6849105370316153 -5.552287708210368e-07 -0.08764101217884585 +0.8953000000000001 0.6849170871187137 0.6849169709458661 -5.435737269743335e-07 -0.08764453466344893 +0.8954000000000001 0.6849235089557781 0.6849234029657909 -5.318125345377123e-07 -0.08764805621018462 +0.8955 0.6849299291447492 0.684929833090747 -5.199477610406955e-07 -0.08765157681926507 +0.8956000000000001 0.6849363476871162 0.6849362613201184 -5.079819960368548e-07 -0.08765509649090222 +0.8957 0.6849427645843418 0.684942687653316 -4.959178504168604e-07 -0.08765861522530805 +0.8958 0.6849491798378606 0.6849491120897782 -4.837579559990868e-07 -0.08766213302269453 +0.8959000000000001 0.6849555934490801 0.6849555346289706 -4.715049648565395e-07 -0.08766564988327359 +0.896 0.6849620054193799 0.6849619552703867 -4.5916154869929393e-07 -0.08766916580725717 +0.8961 0.684968415750111 0.684968374013548 -4.467303984026505e-07 -0.08767268079485713 +0.8962 0.6849748244425968 0.684974790858004 -4.342142233479396e-07 -0.0876761948462853 +0.8963000000000001 0.6849812314981321 0.6849812058033327 -4.216157508535323e-07 -0.08767970796175359 +0.8964000000000001 0.6849876369179826 0.6849876188491398 -4.089377255919735e-07 -0.0876832201414737 +0.8965 0.6849940407033858 0.6849940299950606 -3.9618290893078667e-07 -0.08768673138565747 +0.8966000000000001 0.6850004428555498 0.6850004392407587 -3.833540784398126e-07 -0.08769024169451663 +0.8967 0.6850068433756539 0.6850068465859268 -3.704540272042589e-07 -0.08769375106826288 +0.8968 0.6850132422648476 0.6850132520302865 -3.574855632418328e-07 -0.08769725950710791 +0.8969000000000001 0.6850196395242517 0.685019655573589 -3.4445150886436293e-07 -0.08770076701126339 +0.897 0.6850260351549569 0.685026057215615 -3.3135470015044355e-07 -0.08770427358094102 +0.8971 0.6850324291580242 0.6850324569561743 -3.1819798623072826e-07 -0.08770777921635235 +0.8972 0.6850388215344851 0.6850388547951072 -3.049842287189408e-07 -0.08771128391770902 +0.8973000000000001 0.685045212285341 0.6850452507322826 -2.917163010734969e-07 -0.08771478768522258 +0.8974000000000001 0.6850516014115628 0.6850516447676005 -2.7839708797300355e-07 -0.08771829051910454 +0.8975 0.6850579889140915 0.6850580369009901 -2.6502948468135057e-07 -0.0877217924195664 +0.8976000000000001 0.6850643747938379 0.6850644271324113 -2.516163964613738e-07 -0.08772529338681967 +0.8977 0.6850707590516825 0.6850708154618541 -2.381607379017825e-07 -0.08772879342107581 +0.8978 0.6850771416884751 0.685077201889339 -2.2466543228918945e-07 -0.08773229252254632 +0.8979000000000001 0.6850835227050345 0.6850835864149163 -2.111334109836105e-07 -0.08773579069144244 +0.898 0.6850899021021495 0.6850899690386676 -1.9756761277661683e-07 -0.0877392879279757 +0.8981 0.6850962798805782 0.6850963497607045 -1.839709832668346e-07 -0.08774278423235739 +0.8982 0.6851026560410469 0.6851027285811697 -1.7034647419034155e-07 -0.0877462796047988 +0.8983000000000001 0.6851090305842524 0.6851091055002361 -1.5669704280657504e-07 -0.08774977404551129 +0.8984000000000001 0.68511540351086 0.6851154805181078 -1.4302565126168842e-07 -0.08775326755470611 +0.8985 0.6851217748215034 0.6851218536350194 -1.2933526591721312e-07 -0.08775676013259448 +0.8986000000000001 0.6851281445167863 0.6851282248512365 -1.1562885672208867e-07 -0.08776025177938762 +0.8987 0.685134512597281 0.6851345941670552 -1.0190939657948872e-07 -0.08776374249529673 +0.8988 0.6851408790635287 0.6851409615828035 -8.817986067721773e-08 -0.087767232280533 +0.8989000000000001 0.6851472439160395 0.685147327098839 -7.44432258588737e-08 -0.08777072113530754 +0.899 0.6851536071552926 0.6851536907155509 -6.070246998200052e-08 -0.08777420905983147 +0.8991 0.6851599687817362 0.6851600524333594 -4.696057126583192e-08 -0.08777769605431586 +0.8992 0.6851663287957868 0.6851664122527155 -3.322050764120385e-08 -0.08778118211897178 +0.8993000000000001 0.6851726871978305 0.685172770174101 -1.948525611456149e-08 -0.08778466725401028 +0.8994000000000001 0.6851790439882219 0.6851791261980287 -5.75779211461902e-09 -0.08778815145964226 +0.8995 0.6851853991672852 0.6851854803250422 7.958911146452308e-09 -0.08779163473607882 +0.8996000000000001 0.6851917527353126 0.6851918325557163 2.1661883315739205e-08 -0.08779511708353087 +0.8997 0.6851981046925665 0.6851981828906559 3.534815755899812e-08 -0.08779859850220932 +0.8998 0.6852044550392772 0.6852045313304976 4.901477117583153e-08 -0.08780207899232507 +0.8999000000000001 0.685210803775645 0.6852108778759081 6.265876627102596e-08 -0.08780555855408902 +0.9 0.685217150901839 0.6852172225275844 7.62771903608378e-08 -0.08780903718771194 +0.9001 0.6852234964179977 0.6852235652862553 8.986709704519869e-08 -0.08781251489340475 +0.9002 0.6852298403242285 0.6852299061526791 1.0342554662701176e-07 -0.08781599167137813 +0.9003000000000001 0.6852361826206087 0.6852362451276447 1.1694960676614241e-07 -0.08781946752184289 +0.9004000000000001 0.685242523307185 0.685242582211972 1.3043635308310209e-07 -0.08782294244500984 +0.9005 0.6852488623839732 0.6852489174065105 1.4388286982344733e-07 -0.08782641644108954 +0.9006000000000001 0.6852551998509594 0.6852552507121403 1.5728625045105527e-07 -0.0878298895102928 +0.9007000000000001 0.6852615357080988 0.6852615821297714 1.7064359832119624e-07 -0.0878333616528302 +0.9008 0.6852678699553169 0.6852679116603437 1.8395202728421767e-07 -0.08783683286891242 +0.9009000000000001 0.6852742025925087 0.6852742393048272 1.9720866231351386e-07 -0.08784030315874998 +0.901 0.6852805336195402 0.6852805650642217 2.1041064011961819e-07 -0.08784377252255356 +0.9011 0.6852868630362468 0.6852868889395567 2.2355510977123405e-07 -0.08784724096053367 +0.9012 0.6852931908424345 0.6852932109318903 2.3663923332667425e-07 -0.0878507084729008 +0.9013000000000001 0.6852995170378795 0.6852995310423109 2.496601864340753e-07 -0.0878541750598654 +0.9014000000000001 0.6853058416223294 0.6853058492719362 2.626151589246728e-07 -0.08785764072163806 +0.9015 0.685312164595502 0.685312165621912 2.755013554581187e-07 -0.08786110545842912 +0.9016000000000001 0.6853184859570862 0.6853184800934138 2.8831599607065383e-07 -0.08786456927044904 +0.9017000000000001 0.6853248057067421 0.6853247926876455 3.0105631687593615e-07 -0.08786803215790823 +0.9018 0.6853311238441011 0.6853311034058396 3.137195705160689e-07 -0.08787149412101698 +0.9019000000000001 0.6853374403687658 0.6853374122492571 3.2630302689712343e-07 -0.08787495515998567 +0.902 0.6853437552803106 0.685343719219187 3.3880397372343385e-07 -0.08787841527502457 +0.9021 0.6853500685782818 0.6853500243169464 3.5121971701801424e-07 -0.087881874466344 +0.9022 0.685356380262198 0.6853563275438801 3.635475818025702e-07 -0.08788533273415419 +0.9023000000000001 0.6853626903315497 0.6853626289013606 3.757849126317936e-07 -0.08788879007866536 +0.9024000000000001 0.6853689987857997 0.6853689283907876 3.879290741484742e-07 -0.08789224650008769 +0.9025 0.6853753056243842 0.6853752260135881 3.9997745168718346e-07 -0.08789570199863136 +0.9026000000000001 0.6853816108467112 0.6853815217712164 4.119274518571414e-07 -0.08789915657450653 +0.9027000000000001 0.6853879144521631 0.6853878156651528 4.237765029724283e-07 -0.08790261022792333 +0.9028 0.6853942164400946 0.6853941076969049 4.3552205578056835e-07 -0.08790606295909183 +0.9029 0.6854005168098343 0.6854003978680059 4.4716158394131345e-07 -0.08790951476822206 +0.903 0.6854068155606848 0.6854066861800152 4.586925844429768e-07 -0.0879129656555241 +0.9031 0.6854131126919227 0.6854129726345184 4.701125784351001e-07 -0.08791641562120797 +0.9032 0.6854194082027986 0.6854192572331259 4.814191114366206e-07 -0.08791986466548357 +0.9033000000000001 0.6854257020925384 0.6854255399774736 4.92609754113027e-07 -0.08792331278856091 +0.9034000000000001 0.6854319943603423 0.6854318208692226 5.036821026510596e-07 -0.08792675999064992 +0.9035 0.6854382850053857 0.6854380999100588 5.146337793277e-07 -0.08793020627196046 +0.9036000000000001 0.6854445740268198 0.685444377101692 5.254624329958935e-07 -0.08793365163270246 +0.9037000000000001 0.6854508614237707 0.6854506524458568 5.361657397090491e-07 -0.08793709607308572 +0.9038 0.6854571471953412 0.6854569259443111 5.467414030679851e-07 -0.0879405395933201 +0.9039 0.6854634313406102 0.6854631975988367 5.571871546650176e-07 -0.08794398219361532 +0.904 0.6854697138586328 0.6854694674112387 5.675007548888722e-07 -0.08794742387418121 +0.9041 0.6854759947484415 0.6854757353833452 5.776799930357068e-07 -0.08795086463522747 +0.9042 0.6854822740090456 0.6854820015170064 5.877226880307562e-07 -0.08795430447696384 +0.9043000000000001 0.685488551639432 0.6854882658140955 5.976266887197657e-07 -0.08795774339959996 +0.9044000000000001 0.6854948276385653 0.6854945282765077 6.073898745628803e-07 -0.08796118140334547 +0.9045 0.6855011020053885 0.6855007889061597 6.17010155842812e-07 -0.08796461848841007 +0.9046000000000001 0.6855073747388228 0.6855070477049897 6.264854742060733e-07 -0.0879680546550033 +0.9047000000000001 0.6855136458377682 0.685513304674957 6.358138031348215e-07 -0.08797148990333475 +0.9048 0.6855199153011039 0.6855195598180414 6.449931483493154e-07 -0.08797492423361397 +0.9049 0.6855261831276885 0.6855258131362432 6.540215483769041e-07 -0.08797835764605047 +0.905 0.6855324493163604 0.6855320646315832 6.628970746630491e-07 -0.08798179014085375 +0.9051 0.6855387138659381 0.6855383143061011 6.716178323207256e-07 -0.08798522171823327 +0.9052 0.6855449767752211 0.6855445621618568 6.80181960296955e-07 -0.08798865237839851 +0.9053000000000001 0.6855512380429887 0.6855508082009283 6.885876318862838e-07 -0.08799208212155882 +0.9054000000000001 0.6855574976680023 0.6855570524254126 6.968330550499724e-07 -0.08799551094792357 +0.9055 0.6855637556490046 0.6855632948374253 7.049164728323287e-07 -0.08799893885770216 +0.9056000000000001 0.6855700119847203 0.6855695354390996 7.128361638741865e-07 -0.0880023658511039 +0.9057000000000001 0.6855762666738563 0.6855757742325859 7.205904424267828e-07 -0.08800579192833805 +0.9058 0.6855825197151022 0.6855820112200521 7.281776591011591e-07 -0.0880092170896139 +0.9059 0.685588771107131 0.6855882464036832 7.355962010902051e-07 -0.08801264133514075 +0.906 0.685595020848599 0.6855944797856802 7.428444923213151e-07 -0.0880160646651278 +0.9061 0.6856012689381459 0.6856007113682597 7.499209941502771e-07 -0.08801948707978416 +0.9062 0.6856075153743961 0.6856069411536545 7.568242052780061e-07 -0.08802290857931906 +0.9063000000000001 0.6856137601559588 0.6856131691441127 7.635526623611666e-07 -0.08802632916394167 +0.9064000000000001 0.6856200032814277 0.6856193953418968 7.701049402619731e-07 -0.08802974883386101 +0.9065 0.6856262447493826 0.6856256197492836 7.764796523257456e-07 -0.08803316758928625 +0.9066000000000001 0.6856324845583885 0.6856318423685643 7.826754507000988e-07 -0.08803658543042642 +0.9067000000000001 0.6856387227069971 0.6856380632020438 7.886910265431091e-07 -0.08804000235749056 +0.9068 0.6856449591937465 0.6856442822520391 7.945251104118922e-07 -0.08804341837068758 +0.9069 0.6856511940171619 0.6856504995208814 8.001764724846483e-07 -0.08804683347022652 +0.907 0.6856574271757556 0.6856567150109139 8.056439227827061e-07 -0.0880502476563163 +0.9071 0.6856636586680287 0.6856629287244909 8.109263114203236e-07 -0.0880536609291658 +0.9072 0.6856698884924701 0.685669140663979 8.160225290348988e-07 -0.08805707328898399 +0.9073000000000001 0.6856761166475575 0.6856753508317557 8.209315067175815e-07 -0.08806048473597967 +0.9074000000000001 0.6856823431317575 0.6856815592302097 8.256522164018509e-07 -0.08806389527036174 +0.9075 0.6856885679435267 0.6856877658617387 8.301836711688271e-07 -0.08806730489233894 +0.9076000000000001 0.6856947910813118 0.6856939707287515 8.345249252472708e-07 -0.08807071360212007 +0.9077000000000001 0.6857010125435492 0.6857001738336657 8.386750743466509e-07 -0.08807412139991388 +0.9078 0.6857072323286668 0.6857063751789079 8.426332559485772e-07 -0.08807752828592912 +0.9079 0.6857134504350841 0.685712574766913 8.463986491402675e-07 -0.08808093426037447 +0.908 0.6857196668612118 0.6857187726001246 8.499704751974146e-07 -0.08808433932345858 +0.9081 0.6857258816054526 0.6857249686809932 8.533479974315306e-07 -0.08808774347539008 +0.9082 0.6857320946662027 0.6857311630119769 8.565305214952579e-07 -0.0880911467163776 +0.9083000000000001 0.6857383060418509 0.6857373555955406 8.595173954933921e-07 -0.08809454904662978 +0.9084000000000001 0.6857445157307794 0.6857435464341555 8.623080101355374e-07 -0.08809795046635509 +0.9085 0.6857507237313646 0.6857497355302984 8.649017988471286e-07 -0.0881013509757621 +0.9086000000000001 0.6857569300419772 0.6857559228864519 8.672982378804539e-07 -0.08810475057505934 +0.9087000000000001 0.6857631346609828 0.6857621085051033 8.694968464117991e-07 -0.08810814926445525 +0.9088 0.6857693375867422 0.6857682923887448 8.714971866663479e-07 -0.08811154704415827 +0.9089 0.6857755388176121 0.6857744745398722 8.732988640153261e-07 -0.08811494391437685 +0.909 0.6857817383519456 0.6857806549609848 8.749015269760019e-07 -0.08811833987531936 +0.9091 0.6857879361880922 0.685786833654586 8.763048673365859e-07 -0.08812173492719422 +0.9092 0.6857941323243983 0.6857930106231811 8.775086202394977e-07 -0.08812512907020967 +0.9093000000000001 0.6858003267592084 0.6857991858692778 8.785125642923886e-07 -0.08812852230457409 +0.9094000000000001 0.6858065194908647 0.6858053593953859 8.793165214016074e-07 -0.08813191463049573 +0.9095 0.6858127105177079 0.6858115312040161 8.799203569387348e-07 -0.08813530604818283 +0.9096000000000001 0.6858188998380776 0.6858177012976807 8.803239797683382e-07 -0.08813869655784366 +0.9097000000000001 0.6858250874503129 0.6858238696788921 8.80527342247972e-07 -0.08814208615968638 +0.9098 0.6858312733527527 0.6858300363501624 8.805304403253222e-07 -0.08814547485391921 +0.9099 0.6858374575437363 0.6858362013140038 8.80333313232895e-07 -0.08814886264075028 +0.91 0.6858436400216033 0.6858423645729272 8.799360437655723e-07 -0.08815224952038768 +0.9101 0.6858498207846949 0.6858485261294426 8.7933875829449e-07 -0.08815563549303951 +0.9102 0.6858559998313538 0.6858546859860577 8.785416263923373e-07 -0.08815902055891382 +0.9103000000000001 0.685862177159925 0.685860844145278 8.775448610415237e-07 -0.08816240471821866 +0.9104000000000001 0.6858683527687557 0.685867000609607 8.76348718634179e-07 -0.08816578797116204 +0.9105 0.6858745266561963 0.685873155381544 8.74953498777864e-07 -0.08816917031795196 +0.9106000000000001 0.6858806988206007 0.6858793084635855 8.733595441429154e-07 -0.08817255175879629 +0.9107000000000001 0.6858868692603264 0.6858854598582232 8.715672407538788e-07 -0.088175932293903 +0.9108 0.6858930379737355 0.6858916095679453 8.695770172817419e-07 -0.08817931192347997 +0.9109 0.685899204959195 0.6858977575952341 8.673893455990456e-07 -0.0881826906477351 +0.911 0.685905370215077 0.685903903942567 8.650047402664063e-07 -0.08818606846687621 +0.9111 0.685911533739759 0.6859100486124154 8.6242375850476e-07 -0.08818944538111105 +0.9112 0.6859176955316251 0.6859161916072445 8.596470000982182e-07 -0.08819282139064745 +0.9113000000000001 0.6859238555890659 0.685922332929513 8.56675107269167e-07 -0.08819619649569321 +0.9114000000000001 0.6859300139104788 0.6859284725816719 8.535087644284678e-07 -0.08819957069645604 +0.9115 0.6859361704942687 0.6859346105661647 8.501486982032125e-07 -0.08820294399314359 +0.9116000000000001 0.6859423253388484 0.6859407468854275 8.465956770342675e-07 -0.08820631638596356 +0.9117000000000001 0.6859484784426388 0.685946881541887 8.428505113011742e-07 -0.08820968787512358 +0.9118 0.6859546298040704 0.6859530145379613 8.389140527947925e-07 -0.08821305846083127 +0.9119 0.6859607794215818 0.6859591458760599 8.347871948422014e-07 -0.08821642814329424 +0.912 0.6859669272936221 0.6859652755585817 8.304708718070986e-07 -0.08821979692272007 +0.9121 0.6859730734186497 0.6859714035879153 8.259660591869444e-07 -0.08822316479931624 +0.9122 0.685979217795134 0.6859775299664391 8.212737731688735e-07 -0.08822653177329029 +0.9123000000000001 0.685985360421555 0.6859836546965203 8.163950704909162e-07 -0.08822989784484962 +0.9124000000000001 0.6859915012964042 0.6859897777805147 8.113310482615876e-07 -0.08823326301420176 +0.9125 0.6859976404181847 0.6859958992207662 8.06082843612943e-07 -0.08823662728155407 +0.9126000000000001 0.6860037777854118 0.6860020190196063 8.006516333397551e-07 -0.08823999064711402 +0.9127000000000001 0.6860099133966134 0.6860081371793538 7.950386339689031e-07 -0.08824335311108888 +0.9128000000000001 0.6860160472503304 0.6860142537023146 7.892451011903834e-07 -0.08824671467368606 +0.9129 0.6860221793451171 0.6860203685907809 7.832723296768984e-07 -0.08825007533511287 +0.913 0.6860283096795414 0.6860264818470305 7.771216528340563e-07 -0.08825343509557654 +0.9131 0.6860344382521857 0.6860325934733277 7.707944425228153e-07 -0.08825679395528435 +0.9132 0.6860405650616465 0.6860387034719215 7.642921086986609e-07 -0.08826015191444356 +0.9133000000000001 0.6860466901065354 0.686044811845046 7.576160990230285e-07 -0.0882635089732613 +0.9134000000000001 0.6860528133854797 0.6860509185949195 7.507678986967692e-07 -0.08826686513194473 +0.9135 0.6860589348971222 0.6860570237237448 7.437490300438165e-07 -0.08827022039070107 +0.9136 0.6860650546401222 0.6860631272337083 7.365610521642418e-07 -0.0882735747497374 +0.9137000000000001 0.6860711726131548 0.6860692291269794 7.292055606428205e-07 -0.08827692820926075 +0.9138000000000001 0.6860772888149124 0.6860753294057107 7.216841871882096e-07 -0.08828028076947822 +0.9139 0.6860834032441048 0.6860814280720375 7.139985991472253e-07 -0.08828363243059685 +0.914 0.6860895158994592 0.6860875251280771 7.061504994215761e-07 -0.0882869831928236 +0.9141 0.6860956267797211 0.6860936205759287 6.981416257739737e-07 -0.0882903330563655 +0.9142 0.6861017358836541 0.6860997144176731 6.899737505783321e-07 -0.08829368202142945 +0.9143000000000001 0.6861078432100403 0.686105806655372 6.816486805838462e-07 -0.08829703008822237 +0.9144000000000001 0.6861139487576813 0.6861118972910678 6.731682561933461e-07 -0.08830037725695113 +0.9145 0.6861200525253983 0.6861179863267838 6.645343513245194e-07 -0.08830372352782265 +0.9146 0.6861261545120318 0.6861240737645229 6.557488729103111e-07 -0.08830706890104373 +0.9147000000000001 0.6861322547164425 0.6861301596062681 6.468137604132007e-07 -0.08831041337682118 +0.9148000000000001 0.6861383531375116 0.6861362438539815 6.377309854782576e-07 -0.0883137569553618 +0.9149 0.6861444497741411 0.6861423265096043 6.285025515168075e-07 -0.0883170996368723 +0.915 0.6861505446252539 0.6861484075750566 6.19130493206832e-07 -0.08832044142155938 +0.9151 0.6861566376897948 0.6861544870522366 6.096168760350018e-07 -0.08832378230962977 +0.9152 0.6861627289667299 0.6861605649430209 5.999637958942206e-07 -0.08832712230129011 +0.9153000000000001 0.6861688184550474 0.686166641249264 5.901733786534136e-07 -0.08833046139674704 +0.9154000000000001 0.6861749061537581 0.6861727159727977 5.80247779560783e-07 -0.08833379959620719 +0.9155 0.6861809920618953 0.6861787891154307 5.701891829107408e-07 -0.0883371368998771 +0.9156 0.6861870761785156 0.6861848606789491 5.599998014471641e-07 -0.08834047330796337 +0.9157000000000001 0.6861931585026977 0.6861909306651154 5.496818759470612e-07 -0.08834380882067243 +0.9158000000000001 0.6861992390335454 0.6861969990756681 5.392376747903604e-07 -0.08834714343821087 +0.9159 0.6862053177701855 0.686203065912322 5.286694933492875e-07 -0.08835047716078512 +0.916 0.6862113947117687 0.6862091311767677 5.179796534054981e-07 -0.08835380998860157 +0.9161 0.6862174698574708 0.6862151948706712 5.07170502914156e-07 -0.08835714192186672 +0.9162 0.6862235432064916 0.6862212569956734 4.962444152267764e-07 -0.08836047296078686 +0.9163000000000001 0.6862296147580562 0.6862273175533906 4.852037887442817e-07 -0.08836380310556843 +0.9164000000000001 0.6862356845114147 0.6862333765454138 4.740510463063785e-07 -0.08836713235641772 +0.9165 0.6862417524658424 0.6862394339733078 4.6278863462256847e-07 -0.088370460713541 +0.9166 0.6862478186206409 0.6862454898386124 4.5141902388357025e-07 -0.0883737881771446 +0.9167000000000001 0.6862538829751367 0.6862515441428407 4.3994470706743005e-07 -0.0883771147474347 +0.9168000000000001 0.6862599455286833 0.6862575968874799 4.2836819952318805e-07 -0.08838044042461754 +0.9169 0.6862660062806601 0.6862636480739903 4.166920382700501e-07 -0.08838376520889925 +0.917 0.6862720652304732 0.686269697703806 4.049187815532984e-07 -0.08838708910048604 +0.9171 0.6862781223775556 0.686275745778334 3.930510082544858e-07 -0.08839041209958404 +0.9172 0.6862841777213673 0.6862817922989535 3.8109131735714064e-07 -0.08839373420639929 +0.9173000000000001 0.6862902312613955 0.6862878372670176 3.690423272945109e-07 -0.08839705542113799 +0.9174000000000001 0.6862962829971543 0.6862938806838503 3.569066754638417e-07 -0.08840037574400604 +0.9175 0.6863023329281859 0.6862999225507492 3.4468701764350795e-07 -0.08840369517520946 +0.9176 0.6863083810540604 0.6863059628689834 3.3238602732688083e-07 -0.08840701371495435 +0.9177000000000001 0.6863144273743756 0.6863120016397934 3.200063952296661e-07 -0.08841033136344657 +0.9178000000000001 0.6863204718887574 0.6863180388643924 3.0755082866540384e-07 -0.08841364812089209 +0.9179 0.6863265145968604 0.6863240745439643 2.9502205098341783e-07 -0.0884169639874968 +0.918 0.6863325554983671 0.6863301086796647 2.824228009096208e-07 -0.08842027896346655 +0.9181 0.686338594592989 0.6863361412726205 2.6975583201221953e-07 -0.08842359304900715 +0.9182 0.6863446318804661 0.6863421723239297 2.5702391206333663e-07 -0.08842690624432453 +0.9183000000000001 0.6863506673605677 0.6863482018346609 2.4422982244226565e-07 -0.0884302185496244 +0.9184000000000001 0.686356701033092 0.686354229805854 2.313763575595429e-07 -0.08843352996511256 +0.9185 0.6863627328978659 0.6863602562385188 2.1846632419775247e-07 -0.08843684049099462 +0.9186 0.6863687629547461 0.6863662811336364 2.0550254091478148e-07 -0.0884401501274764 +0.9187000000000001 0.686374791203619 0.6863723044921582 1.924878374331973e-07 -0.08844345887476356 +0.9188000000000001 0.6863808176444 0.6863783263150057 1.7942505404003328e-07 -0.08844676673306173 +0.9189 0.6863868422770341 0.6863843466030706 1.6631704096228828e-07 -0.08845007370257653 +0.919 0.6863928651014963 0.6863903653572145 1.5316665773895677e-07 -0.08845337978351352 +0.9191 0.6863988861177914 0.6863963825782695 1.3997677254795615e-07 -0.08845668497607827 +0.9192 0.6864049053259542 0.6864023982670373 1.26750261664893e-07 -0.08845998928047633 +0.9193000000000001 0.6864109227260491 0.6864084124242897 1.1349000879345983e-07 -0.08846329269691314 +0.9194000000000001 0.6864169383181711 0.6864144250507682 1.0019890442705681e-07 -0.08846659522559426 +0.9195 0.6864229521024449 0.6864204361471837 8.687984525204695e-08 -0.08846989686672509 +0.9196 0.6864289640790254 0.6864264457142173 7.353573348856113e-08 -0.08847319762051106 +0.9197000000000001 0.6864349742480982 0.6864324537525192 6.016947625905877e-08 -0.08847649748715754 +0.9198000000000001 0.6864409826098785 0.6864384602627092 4.6783984977705195e-08 -0.08847979646686989 +0.9199 0.6864469891646128 0.6864444652453772 3.338217469638083e-08 -0.08848309455985348 +0.92 0.6864529939125766 0.686450468701082 1.9966963473241894e-08 -0.08848639176631358 +0.9201 0.6864589968540769 0.6864564706303521 6.541271733474796e-09 -0.08848968808645546 +0.9202 0.6864649979894504 0.6864624710336854 -6.891978348265437e-09 -0.08849298352048436 +0.9203000000000001 0.6864709973190648 0.6864684699115493 -2.032986350141222e-08 -0.08849627806860551 +0.9204000000000001 0.6864769948433178 0.6864744672643802 -3.3769459989625716e-08 -0.08849957173102409 +0.9205 0.6864829905626377 0.6864804630925846 -4.7207844250634744e-08 -0.08850286450794526 +0.9206 0.6864889844774833 0.6864864573965381 -6.064209352599562e-08 -0.08850615639957418 +0.9207000000000001 0.6864949765883435 0.6864924501765856 -7.406928650153036e-08 -0.08850944740611591 +0.9208000000000001 0.6865009668957376 0.6864984414330417 -8.74865039406092e-08 -0.08851273752777553 +0.9209 0.6865069554002154 0.6865044311661905 -1.00890829324643e-07 -0.08851602676475807 +0.921 0.6865129421023572 0.6865104193762855 -1.1427934946961482e-07 -0.08851931511726861 +0.9211 0.6865189270027734 0.6865164060635498 -1.2764915519221376e-07 -0.08852260258551208 +0.9212 0.6865249101021043 0.6865223912281762 -1.4099734189747248e-07 -0.08852588916969346 +0.9213000000000001 0.6865308914010209 0.6865283748703271 -1.5432101026745249e-07 -0.08852917487001771 +0.9214000000000001 0.6865368709002238 0.6865343569901347 -1.676172668180903e-07 -0.08853245968668969 +0.9215 0.6865428486004443 0.6865403375877007 -1.8088322461043416e-07 -0.08853574361991429 +0.9216 0.6865488245024429 0.6865463166630974 -1.9411600379881655e-07 -0.08853902666989634 +0.9217000000000001 0.6865547986070105 0.686552294216366 -2.0731273232127423e-07 -0.08854230883684067 +0.9218000000000001 0.6865607709149677 0.6865582702475188 -2.2047054646506803e-07 -0.08854559012095208 +0.9219 0.6865667414271648 0.6865642447565374 -2.3358659155189865e-07 -0.08854887052243529 +0.922 0.6865727101444813 0.6865702177433746 -2.466580225034265e-07 -0.08855215004149504 +0.9221 0.6865786770678268 0.6865761892079522 -2.596820045039361e-07 -0.08855542867833605 +0.9222 0.6865846421981404 0.6865821591501635 -2.726557135485086e-07 -0.08855870643316299 +0.9223000000000001 0.68659060553639 0.686588127569872 -2.8557633712997244e-07 -0.08856198330618051 +0.9224000000000001 0.6865965670835725 0.6865940944669119 -2.9844107482523974e-07 -0.08856525929759321 +0.9225 0.6866025268407145 0.6866000598410884 -3.1124713885388733e-07 -0.0885685344076057 +0.9226 0.6866084848088707 0.6866060236921776 -3.2399175475816833e-07 -0.0885718086364225 +0.9227000000000001 0.6866144409891253 0.6866119860199261 -3.366721619754709e-07 -0.08857508198424813 +0.9228000000000001 0.6866203953825905 0.6866179468240527 -3.492856144177159e-07 -0.08857835445128713 +0.9229 0.6866263479904073 0.6866239061042472 -3.6182938110279617e-07 -0.08858162603774397 +0.923 0.6866322988137447 0.6866298638601709 -3.743007466749937e-07 -0.08858489674382307 +0.9231 0.6866382478537998 0.6866358200914571 -3.866970120849911e-07 -0.08858816656972887 +0.9232 0.6866441951117979 0.6866417747977105 -3.9901549513804424e-07 -0.0885914355156657 +0.9233000000000001 0.6866501405889918 0.6866477279785085 -4.1125353101439943e-07 -0.08859470358183796 +0.9234000000000001 0.6866560842866618 0.6866536796334006 -4.2340847295624373e-07 -0.08859797076845001 +0.9235 0.6866620262061158 0.686659629761909 -4.354776927742443e-07 -0.08860123707570611 +0.9236 0.6866679663486888 0.6866655783635276 -4.474585814165377e-07 -0.08860450250381051 +0.9237000000000001 0.6866739047157423 0.6866715254377244 -4.593485495377192e-07 -0.08860776705296747 +0.9238000000000001 0.6866798413086654 0.6866774709839399 -4.7114502813028203e-07 -0.08861103072338122 +0.9239 0.6866857761288733 0.6866834150015881 -4.828454689270734e-07 -0.08861429351525595 +0.924 0.6866917091778071 0.6866893574900563 -4.944473450951836e-07 -0.08861755542879578 +0.9241 0.6866976404569342 0.6866952984487058 -5.059481516800357e-07 -0.08862081646420478 +0.9242 0.6867035699677484 0.6867012378768718 -5.17345406257641e-07 -0.0886240766216872 +0.9243000000000001 0.6867094977117685 0.6867071757738636 -5.286366493856276e-07 -0.08862733590144696 +0.9244000000000001 0.6867154236905391 0.6867131121389652 -5.398194451999849e-07 -0.08863059430368818 +0.9245 0.6867213479056293 0.6867190469714356 -5.508913818175198e-07 -0.08863385182861488 +0.9246 0.6867272703586337 0.6867249802705082 -5.618500719950514e-07 -0.08863710847643103 +0.9247000000000001 0.6867331910511709 0.6867309120353917 -5.726931535665614e-07 -0.08864036424734051 +0.9248000000000001 0.6867391099848844 0.6867368422652708 -5.834182899844276e-07 -0.08864361914154732 +0.9249 0.6867450271614415 0.6867427709593057 -5.940231708745358e-07 -0.08864687315925536 +0.925 0.6867509425825332 0.6867486981166324 -6.045055122999576e-07 -0.08865012630066846 +0.9251 0.686756856249874 0.6867546237363638 -6.148630576907621e-07 -0.08865337856599043 +0.9252 0.6867627681652018 0.6867605478175893 -6.250935779134048e-07 -0.08865662995542518 +0.9253000000000001 0.6867686783302771 0.6867664703593748 -6.351948718535949e-07 -0.08865988046917643 +0.9254000000000001 0.6867745867468831 0.6867723913607635 -6.451647670546734e-07 -0.08866313010744786 +0.9255 0.6867804934168257 0.686778310820777 -6.550011199951689e-07 -0.08866637887044326 +0.9256 0.6867863983419323 0.6867842287384134 -6.647018167549312e-07 -0.08866962675836633 +0.9257000000000001 0.6867923015240525 0.6867901451126501 -6.742647732510543e-07 -0.08867287377142075 +0.9258000000000001 0.6867982029650568 0.6867960599424422 -6.836879357374759e-07 -0.08867611990981011 +0.9259000000000001 0.6868041026668369 0.6868019732267242 -6.929692814433563e-07 -0.08867936517373803 +0.926 0.6868100006313054 0.686807884964409 -7.02106818725734e-07 -0.08868260956340808 +0.9261 0.686815896860395 0.6868137951543896 -7.110985876940257e-07 -0.08868585307902382 +0.9262 0.686821791356059 0.6868197037955384 -7.199426605292158e-07 -0.0886890957207888 +0.9263000000000001 0.6868276841202698 0.6868256108867078 -7.286371419695792e-07 -0.08869233748890644 +0.9264000000000001 0.6868335751550201 0.6868315164267309 -7.37180169671503e-07 -0.08869557838358025 +0.9265 0.6868394644623201 0.6868374204144218 -7.455699145980654e-07 -0.08869881840501362 +0.9266 0.6868453520441999 0.6868433228485753 -7.538045814631245e-07 -0.08870205755340999 +0.9267000000000001 0.6868512379027081 0.6868492237279682 -7.618824091337739e-07 -0.08870529582897274 +0.9268000000000001 0.6868571220399102 0.6868551230513587 -7.698016708940214e-07 -0.08870853323190517 +0.9269000000000001 0.6868630044578905 0.6868610208174872 -7.775606749166331e-07 -0.08871176976241064 +0.927 0.6868688851587494 0.6868669170250772 -7.851577645406893e-07 -0.08871500542069238 +0.9271 0.6868747641446052 0.6868728116728349 -7.925913187434297e-07 -0.08871824020695372 +0.9272 0.6868806414175919 0.6868787047594495 -7.99859752459442e-07 -0.08872147412139779 +0.9273 0.6868865169798603 0.6868845962835947 -8.069615167888289e-07 -0.0887247071642279 +0.9274000000000001 0.6868923908335762 0.6868904862439278 -8.138950993857863e-07 -0.08872793933564715 +0.9275 0.6868982629809213 0.6868963746390904 -8.206590250137147e-07 -0.0887311706358587 +0.9276 0.6869041334240921 0.6869022614677095 -8.272518555174635e-07 -0.08873440106506567 +0.9277000000000001 0.6869100021652996 0.6869081467283973 -8.336721903090538e-07 -0.08873763062347113 +0.9278000000000001 0.6869158692067694 0.6869140304197507 -8.399186666452341e-07 -0.08874085931127812 +0.9279000000000001 0.6869217345507403 0.6869199125403541 -8.459899599189136e-07 -0.0887440871286897 +0.928 0.6869275981994647 0.6869257930887775 -8.518847838673294e-07 -0.08874731407590884 +0.9281 0.6869334601552082 0.6869316720635781 -8.57601890974502e-07 -0.08875054015313855 +0.9282 0.6869393204202485 0.6869375494633 -8.631400726516469e-07 -0.0887537653605817 +0.9283 0.6869451789968759 0.6869434252864752 -8.684981595424857e-07 -0.08875698969844123 +0.9284000000000001 0.6869510358873923 0.686949299531624 -8.736750217175349e-07 -0.08876021316692002 +0.9285 0.6869568910941107 0.6869551721972549 -8.786695688683954e-07 -0.08876343576622092 +0.9286 0.6869627446193556 0.6869610432818651 -8.834807507102083e-07 -0.08876665749654675 +0.9287000000000001 0.6869685964654613 0.6869669127839422 -8.8810755713431e-07 -0.08876987835810025 +0.9288000000000001 0.6869744466347727 0.686972780701962 -8.925490182914997e-07 -0.08877309835108425 +0.9289000000000001 0.6869802951296442 0.6869786470343919 -8.968042048279612e-07 -0.08877631747570149 +0.929 0.6869861419524395 0.6869845117796893 -9.00872228357108e-07 -0.08877953573215465 +0.9291 0.6869919871055308 0.6869903749363026 -9.047522412652942e-07 -0.08878275312064639 +0.9292 0.6869978305912987 0.6869962365026714 -9.084434371420258e-07 -0.08878596964137934 +0.9293 0.6870036724121323 0.6870020964772279 -9.119450508215943e-07 -0.08878918529455614 +0.9294000000000001 0.687009512570428 0.687007954858396 -9.152563586189988e-07 -0.08879240008037936 +0.9295 0.6870153510685889 0.687013811644593 -9.183766784409686e-07 -0.08879561399905164 +0.9296 0.687021187909025 0.6870196668342285 -9.213053698969853e-07 -0.08879882705077542 +0.9297000000000001 0.6870270230941524 0.6870255204257067 -9.240418345074497e-07 -0.08880203923575322 +0.9298000000000001 0.6870328566263934 0.6870313724174254 -9.265855158424596e-07 -0.08880525055418755 +0.9299000000000001 0.6870386885081747 0.6870372228077766 -9.289358995079322e-07 -0.08880846100628076 +0.93 0.6870445187419288 0.6870430715951479 -9.310925132982595e-07 -0.08881167059223535 +0.9301 0.6870503473300924 0.6870489187779218 -9.330549274044753e-07 -0.08881487931225364 +0.9302 0.687056174275106 0.6870547643544771 -9.348227543448662e-07 -0.08881808716653804 +0.9303 0.6870619995794137 0.6870606083231883 -9.363956491731384e-07 -0.08882129415529082 +0.9304000000000001 0.687067823245463 0.6870664506824271 -9.377733094367846e-07 -0.0888245002787143 +0.9305 0.6870736452757037 0.6870722914305623 -9.389554753436169e-07 -0.08882770553701075 +0.9306 0.687079465672588 0.6870781305659599 -9.399419296785005e-07 -0.0888309099303824 +0.9307000000000001 0.6870852844385698 0.6870839680869848 -9.407324979976428e-07 -0.08883411345903142 +0.9308000000000001 0.6870911015761045 0.6870898039919996 -9.413270484204261e-07 -0.08883731612316004 +0.9309000000000001 0.6870969170876484 0.687095638279366 -9.417254920179863e-07 -0.08884051792297042 +0.931 0.6871027309756583 0.6871014709474459 -9.419277824801453e-07 -0.08884371885866468 +0.9311 0.6871085432425904 0.6871073019945995 -9.419339163513341e-07 -0.08884691893044483 +0.9312 0.687114353890901 0.6871131314191887 -9.417439328085475e-07 -0.08885011813851296 +0.9313 0.6871201629230457 0.6871189592195758 -9.413579138278783e-07 -0.08885331648307117 +0.9314000000000001 0.6871259703414778 0.6871247853941238 -9.407759841428831e-07 -0.0888565139643214 +0.9315 0.68713177614865 0.6871306099411973 -9.399983110641719e-07 -0.08885971058246554 +0.9316 0.6871375803470119 0.6871364328591639 -9.390251045349185e-07 -0.08886290633770565 +0.9317000000000001 0.6871433829390112 0.687142254146393 -9.37856617269639e-07 -0.08886610123024362 +0.9318000000000001 0.6871491839270916 0.6871480738012572 -9.364931442268354e-07 -0.08886929526028134 +0.9319000000000001 0.6871549833136937 0.6871538918221323 -9.349350229420628e-07 -0.08887248842802062 +0.932 0.6871607811012541 0.6871597082073979 -9.331826333613957e-07 -0.08887568073366331 +0.9321 0.687166577292205 0.6871655229554383 -9.312363975638727e-07 -0.08887887217741121 +0.9322 0.6871723718889735 0.6871713360646421 -9.290967799696626e-07 -0.08888206275946607 +0.9323 0.6871781648939816 0.6871771475334038 -9.267642869098536e-07 -0.08888525248002971 +0.9324000000000001 0.6871839563096456 0.6871829573601225 -9.242394667791087e-07 -0.08888844133930376 +0.9325 0.6871897461383751 0.6871887655432038 -9.215229097303546e-07 -0.08889162933748992 +0.9326 0.6871955343825733 0.6871945720810599 -9.186152476192699e-07 -0.0888948164747898 +0.9327000000000001 0.6872013210446364 0.68720037697211 -9.155171538238749e-07 -0.08889800275140503 +0.9328000000000001 0.6872071061269533 0.6872061802147803 -9.12229343147386e-07 -0.08890118816753723 +0.9329000000000001 0.6872128896319046 0.6872119818075049 -9.087525715545386e-07 -0.08890437272338796 +0.933 0.6872186715618629 0.6872177817487263 -9.050876361021976e-07 -0.08890755641915872 +0.9331 0.6872244519191912 0.6872235800368951 -9.01235374717313e-07 -0.088910739255051 +0.9332 0.6872302307062444 0.6872293766704716 -8.971966660165087e-07 -0.08891392123126625 +0.9333 0.6872360079253673 0.6872351716479256 -8.929724290701602e-07 -0.088917102348006 +0.9334000000000001 0.6872417835788943 0.6872409649677362 -8.885636232081051e-07 -0.08892028260547162 +0.9335 0.6872475576691497 0.6872467566283935 -8.839712478947437e-07 -0.08892346200386447 +0.9336 0.6872533301984469 0.6872525466283979 -8.791963423404603e-07 -0.08892664054338599 +0.9337000000000001 0.6872591011690878 0.6872583349662609 -8.742399854044791e-07 -0.08892981822423741 +0.9338000000000001 0.6872648705833627 0.6872641216405055 -8.691032952895528e-07 -0.08893299504662006 +0.9339000000000001 0.6872706384435496 0.6872699066496673 -8.637874292782843e-07 -0.08893617101073521 +0.934 0.6872764047519146 0.6872756899922938 -8.582935835665939e-07 -0.08893934611678411 +0.9341 0.6872821695107096 0.6872814716669451 -8.526229928751405e-07 -0.0889425203649679 +0.9342 0.6872879327221744 0.6872872516721951 -8.467769302272776e-07 -0.0889456937554878 +0.9343 0.6872936943885344 0.6872930300066307 -8.407567067408861e-07 -0.08894886628854498 +0.9344000000000001 0.687299454512001 0.687298806668853 -8.345636711704074e-07 -0.08895203796434051 +0.9345 0.6873052130947714 0.6873045816574774 -8.281992097125546e-07 -0.08895520878307549 +0.9346 0.6873109701390274 0.6873103549711342 -8.216647457287563e-07 -0.088958378744951 +0.9347000000000001 0.6873167256469358 0.6873161266084686 -8.149617393427011e-07 -0.08896154785016802 +0.9348000000000001 0.6873224796206479 0.6873218965681416 -8.080916871489041e-07 -0.08896471609892763 +0.9349000000000001 0.6873282320622981 0.6873276648488298 -8.010561218796397e-07 -0.0889678834914307 +0.935 0.6873339829740053 0.6873334314492265 -7.93856612127386e-07 -0.08897105002787825 +0.9351 0.6873397323578714 0.6873391963680414 -7.864947618452245e-07 -0.08897421570847115 +0.9352 0.6873454802159809 0.6873449596040009 -7.789722101803065e-07 -0.08897738053341031 +0.9353 0.6873512265504007 0.6873507211558492 -7.712906309464973e-07 -0.08898054450289657 +0.9354000000000001 0.68735697136318 0.6873564810223481 -7.634517323884538e-07 -0.08898370761713074 +0.9355 0.6873627146563499 0.6873622392022775 -7.554572566265128e-07 -0.08898686987631359 +0.9356 0.6873684564319227 0.6873679956944356 -7.473089794762799e-07 -0.08899003128064592 +0.9357000000000001 0.6873741966918917 0.6873737504976398 -7.390087099351517e-07 -0.08899319183032849 +0.9358000000000001 0.6873799354382311 0.6873795036107259 -7.30558289779859e-07 -0.08899635152556193 +0.9359000000000001 0.6873856726728952 0.6873852550325499 -7.219595932056455e-07 -0.08899951036654694 +0.936 0.6873914083978188 0.6873910047619871 -7.132145264515666e-07 -0.08900266835348418 +0.9361 0.6873971426149159 0.6873967527979331 -7.043250271621115e-07 -0.08900582548657421 +0.9362 0.6874028753260802 0.6874024991393044 -6.95293064290059e-07 -0.0890089817660177 +0.9363 0.6874086065331844 0.6874082437850376 -6.861206372915651e-07 -0.08901213719201516 +0.9364000000000001 0.6874143362380799 0.6874139867340909 -6.768097761261638e-07 -0.08901529176476713 +0.9365 0.6874200644425963 0.6874197279854433 -6.673625403547101e-07 -0.08901844548447406 +0.9366 0.687425791148542 0.6874254675380961 -6.57781018986725e-07 -0.08902159835133644 +0.9367000000000001 0.6874315163577025 0.6874312053910725 -6.480673298836503e-07 -0.08902475036555475 +0.9368000000000001 0.6874372400718411 0.687436941543418 -6.382236193563928e-07 -0.08902790152732933 +0.9369000000000001 0.6874429622926987 0.6874426759942003 -6.282520616379683e-07 -0.08903105183686062 +0.937 0.6874486830219928 0.6874484087425106 -6.181548585504348e-07 -0.08903420129434891 +0.9371 0.6874544022614171 0.6874541397874625 -6.079342387138587e-07 -0.08903734989999448 +0.9372 0.6874601200126427 0.6874598691281943 -5.97592457435292e-07 -0.08904049765399774 +0.9373 0.6874658362773161 0.6874655967638671 -5.871317958761058e-07 -0.08904364455655887 +0.9374000000000001 0.6874715510570595 0.687471322693666 -5.765545608021894e-07 -0.08904679060787808 +0.9375 0.6874772643534715 0.6874770469168006 -5.658630838761836e-07 -0.08904993580815562 +0.9376 0.6874829761681251 0.6874827694325052 -5.550597212966579e-07 -0.08905308015759164 +0.9377000000000001 0.6874886865025693 0.6874884902400384 -5.441468532291216e-07 -0.0890562236563863 +0.9378000000000001 0.6874943953583272 0.6874942093386842 -5.331268832786673e-07 -0.08905936630473965 +0.9379000000000001 0.6875001027368968 0.6874999267277513 -5.220022379209821e-07 -0.08906250810285181 +0.938 0.6875058086397503 0.6875056424065746 -5.10775366002747e-07 -0.0890656490509228 +0.9381 0.6875115130683341 0.6875113563745141 -4.994487382212198e-07 -0.08906878914915267 +0.9382 0.6875172160240688 0.6875170686309564 -4.880248465968795e-07 -0.08907192839774138 +0.9383 0.687522917508348 0.6875227791753138 -4.7650620378647535e-07 -0.0890750667968889 +0.9384000000000001 0.6875286175225399 0.6875284880070249 -4.648953427777158e-07 -0.08907820434679523 +0.9385 0.6875343160679847 0.6875341951255549 -4.5319481618150137e-07 -0.08908134104766013 +0.9386 0.6875400131459963 0.687539900530396 -4.4140719555885166e-07 -0.08908447689968357 +0.9387000000000001 0.6875457087578618 0.6875456042210675 -4.2953507108783873e-07 -0.08908761190306536 +0.9388000000000001 0.6875514029048402 0.6875513061971151 -4.1758105087663644e-07 -0.08909074605800532 +0.9389000000000001 0.6875570955881636 0.6875570064581127 -4.0554776036677564e-07 -0.08909387936470323 +0.939 0.6875627868090366 0.6875627050036612 -3.934378418127271e-07 -0.08909701182335886 +0.9391 0.6875684765686351 0.6875684018333894 -3.8125395373372895e-07 -0.08910014343417189 +0.9392 0.687574164868108 0.6875740969469538 -3.689987701713249e-07 -0.08910327419734207 +0.9393 0.6875798517085752 0.6875797903440389 -3.5667498030772515e-07 -0.089106404113069 +0.9394000000000001 0.6875855370911288 0.6875854820243577 -3.4428528777191714e-07 -0.08910953318155233 +0.9395 0.687591221016832 0.687591171987651 -3.3183240997353147e-07 -0.08911266140299165 +0.9396 0.6875969034867201 0.6875968602336882 -3.1931907770038626e-07 -0.08911578877758657 +0.9397000000000001 0.6876025845017992 0.6876025467622675 -3.067480343413309e-07 -0.0891189153055366 +0.9398000000000001 0.6876082640630465 0.6876082315732155 -2.9412203534501247e-07 -0.08912204098704124 +0.9399000000000001 0.6876139421714103 0.6876139146663878 -2.8144384767170294e-07 -0.08912516582230001 +0.94 0.6876196188278101 0.6876195960416691 -2.687162491028794e-07 -0.08912828981151234 +0.9401 0.6876252940331355 0.6876252756989727 -2.5594202769652075e-07 -0.08913141295487766 +0.9402 0.6876309677882477 0.6876309536382412 -2.431239811348518e-07 -0.08913453525259535 +0.9403 0.6876366400939777 0.6876366298594467 -2.3026491612065936e-07 -0.08913765670486479 +0.9404000000000001 0.6876423109511277 0.6876423043625903 -2.1736764778401696e-07 -0.08914077731188529 +0.9405 0.6876479803604698 0.6876479771477031 -2.0443499906125373e-07 -0.0891438970738562 +0.9406 0.6876536483227467 0.6876536482148446 -1.914698000253512e-07 -0.08914701599097674 +0.9407000000000001 0.6876593148386712 0.6876593175641048 -1.7847488734124006e-07 -0.08915013406344618 +0.9408000000000001 0.6876649799089267 0.687664985195603 -1.654531036170137e-07 -0.08915325129146373 +0.9409000000000001 0.6876706435341662 0.6876706511094883 -1.524072967672846e-07 -0.08915636767522855 +0.941 0.6876763057150134 0.6876763153059391 -1.3934031939388802e-07 -0.08915948321493979 +0.9411 0.6876819664520617 0.6876819777851642 -1.2625502818913725e-07 -0.08916259791079659 +0.9412 0.6876876257458748 0.6876876385474016 -1.1315428328877164e-07 -0.08916571176299806 +0.9413 0.6876932835969862 0.6876932975929195 -1.0004094764398674e-07 -0.08916882477174325 +0.9414000000000001 0.6876989400058996 0.6876989549220162 -8.691788640474013e-08 -0.08917193693723119 +0.9415 0.6877045949730884 0.6877046105350192 -7.378796628917939e-08 -0.08917504825966088 +0.9416 0.687710248498996 0.6877102644322862 -6.065405496261111e-08 -0.0891781587392313 +0.9417000000000001 0.6877159005840359 0.6877159166142048 -4.7519020405844756e-08 -0.08918126837614135 +0.9418000000000001 0.6877215512285917 0.6877215670811927 -3.438573029399894e-08 -0.08918437717059002 +0.9419000000000001 0.6877272004330166 0.6877272158336971 -2.12570513684774e-08 -0.08918748512277613 +0.942 0.6877328481976339 0.6877328628721955 -8.135848808890622e-09 -0.08919059223289855 +0.9421 0.6877384945227372 0.6877385081971947 4.975014391769839e-09 -0.08919369850115612 +0.9422 0.6877441394085896 0.6877441518092318 1.807267805114393e-08 -0.08919680392774759 +0.9423 0.6877497828554245 0.6877497937088732 3.1154285415335714e-08 -0.08919990851287174 +0.9424000000000001 0.6877554248634458 0.6877554338967157 4.42169837983758e-08 -0.08920301225672739 +0.9425 0.6877610654328267 0.6877610723733851 5.7257925187639835e-08 -0.0892061151595131 +0.9426 0.6877667045637115 0.6877667091395374 7.027426686921634e-08 -0.08920921722142763 +0.9427000000000001 0.6877723422562143 0.6877723441958576 8.326317205327449e-08 -0.08921231844266958 +0.9428000000000001 0.6877779785104197 0.6877779775430608 9.62218104916257e-08 -0.0892154188234376 +0.9429000000000001 0.6877836133263826 0.687783609181891 1.0914735908834627e-07 -0.08921851836393029 +0.943 0.6877892467041284 0.687789239113122 1.2203700252427785e-07 -0.08922161706434616 +0.9431 0.6877948786436532 0.6877948673375562 1.3488793387111953e-07 -0.0892247149248837 +0.9432 0.6878005091449237 0.6878004938560263 1.4769735517602967e-07 -0.08922781194574148 +0.9433 0.6878061382078768 0.6878061186693927 1.6046247810000414e-07 -0.08923090812711787 +0.9434000000000001 0.6878117658324218 0.6878117417785458 1.7318052453196842e-07 -0.0892340034692114 +0.9435 0.6878173920184374 0.6878173631844045 1.8584872718205303e-07 -0.08923709797222042 +0.9436 0.6878230167657743 0.6878229828879163 1.9846433015058285e-07 -0.08924019163634332 +0.9437000000000001 0.6878286400742541 0.6878286008900576 2.110245895733942e-07 -0.08924328446177843 +0.9438000000000001 0.68783426194367 0.6878342171918329 2.2352677422204925e-07 -0.08924637644872405 +0.9439000000000001 0.6878398823737863 0.6878398317942753 2.359681660485391e-07 -0.08924946759737845 +0.944 0.6878455013643395 0.6878454446984461 2.483460608548871e-07 -0.08925255790793994 +0.9441 0.6878511189150374 0.6878510559054346 2.606577687719325e-07 -0.0892556473806067 +0.9442 0.6878567350255601 0.687856665416358 2.729006149879143e-07 -0.08925873601557693 +0.9443 0.6878623496955596 0.687862273232361 2.8507194017174387e-07 -0.08926182381304879 +0.9444000000000001 0.6878679629246601 0.6878678793546165 2.97169101180772e-07 -0.08926491077322041 +0.9445 0.6878735747124585 0.687873483784324 3.0918947154651155e-07 -0.08926799689628986 +0.9446 0.6878791850585244 0.6878790865227106 3.2113044211301567e-07 -0.08927108218245527 +0.9447000000000001 0.6878847939624 0.6878846875710303 3.3298942155035594e-07 -0.08927416663191459 +0.9448000000000001 0.6878904014236007 0.687890286930564 3.4476383695830615e-07 -0.08927725024486592 +0.9449000000000001 0.6878960074416148 0.6878958846026193 3.5645113437288156e-07 -0.08928033302150722 +0.945 0.6879016120159045 0.6879014805885304 3.680487794463505e-07 -0.0892834149620364 +0.9451 0.6879072151459049 0.687907074889657 3.7955425779417906e-07 -0.0892864960666514 +0.9452 0.6879128168310258 0.6879126675073859 3.9096507570279826e-07 -0.08928957633555014 +0.9453 0.6879184170706505 0.6879182584431286 4.022787606430822e-07 -0.08929265576893047 +0.9454000000000001 0.6879240158641368 0.6879238476983227 4.134928617560707e-07 -0.0892957343669902 +0.9455 0.6879296132108168 0.687929435274431 4.24604950387264e-07 -0.08929881212992712 +0.9456 0.6879352091099976 0.6879350211729415 4.356126207041844e-07 -0.08930188905793898 +0.9457000000000001 0.6879408035609613 0.6879406053953669 4.465134901265877e-07 -0.08930496515122355 +0.9458000000000001 0.6879463965629651 0.6879461879432446 4.57305199860758e-07 -0.08930804040997856 +0.9459000000000001 0.6879519881152414 0.6879517688181362 4.679854153782914e-07 -0.08931111483440161 +0.946 0.6879575782169994 0.6879573480216278 4.785518270544742e-07 -0.08931418842469044 +0.9461 0.6879631668674232 0.6879629255553286 4.890021505360442e-07 -0.08931726118104258 +0.9462 0.6879687540656736 0.6879685014208721 4.993341272269136e-07 -0.08932033310365566 +0.9463 0.6879743398108883 0.6879740756199144 5.09545524912669e-07 -0.08932340419272722 +0.9464000000000001 0.6879799241021813 0.6879796481541354 5.196341381075165e-07 -0.08932647444845483 +0.9465 0.6879855069386442 0.6879852190252369 5.295977885400038e-07 -0.08932954387103599 +0.9466 0.6879910883193457 0.6879907882349436 5.394343257636436e-07 -0.0893326124606681 +0.9467000000000001 0.6879966682433323 0.6879963557850022 5.491416274205907e-07 -0.08933568021754866 +0.9468000000000001 0.6880022467096284 0.6880019216771811 5.58717599935532e-07 -0.08933874714187502 +0.9469000000000001 0.6880078237172371 0.6880074859132703 5.681601787099755e-07 -0.08934181323384457 +0.947 0.6880133992651397 0.6880130484950813 5.774673287745058e-07 -0.08934487849365468 +0.9471 0.6880189733522966 0.688018609424446 5.866370451079739e-07 -0.08934794292150261 +0.9472 0.6880245459776474 0.6880241687032175 5.956673530815859e-07 -0.08935100651758571 +0.9473 0.6880301171401115 0.6880297263332685 6.045563090140149e-07 -0.08935406928210118 +0.9474000000000001 0.6880356868385883 0.6880352823164922 6.133020004073231e-07 -0.0893571312152463 +0.9475 0.6880412550719567 0.6880408366548012 6.219025464881955e-07 -0.0893601923172182 +0.9476 0.6880468218390768 0.688046389350127 6.303560985132517e-07 -0.08936325258821405 +0.9477000000000001 0.6880523871387894 0.6880519404044205 6.386608402825233e-07 -0.08936631202843098 +0.9478000000000001 0.688057950969917 0.6880574898196514 6.468149884170105e-07 -0.08936937063806616 +0.9479000000000001 0.6880635133312628 0.688063037597807 6.548167928582815e-07 -0.08937242841731662 +0.948 0.6880690742216129 0.6880685837408931 6.626645371599071e-07 -0.08937548536637938 +0.9481 0.6880746336397352 0.6880741282509322 6.703565388344046e-07 -0.08937854148545149 +0.9482 0.6880801915843802 0.688079671129965 6.778911497834494e-07 -0.08938159677472989 +0.9483 0.6880857480542812 0.6880852123800485 6.852667567003312e-07 -0.08938465123441154 +0.9484000000000001 0.6880913030481561 0.688090752003256 6.924817811948536e-07 -0.08938770486469338 +0.9485 0.688096856564705 0.6880962900016769 6.995346804455904e-07 -0.08939075766577227 +0.9486 0.6881024086026133 0.6881018263774171 7.064239472831524e-07 -0.08939380963784511 +0.9487000000000001 0.6881079591605503 0.6881073611325965 7.131481105926429e-07 -0.0893968607811087 +0.9488000000000001 0.6881135082371707 0.688112894269351 7.19705735591214e-07 -0.08939991109575983 +0.9489000000000001 0.6881190558311137 0.6881184257898305 7.260954243276663e-07 -0.08940296058199526 +0.949 0.6881246019410046 0.6881239556961996 7.323158156546938e-07 -0.08940600924001177 +0.9491 0.6881301465654551 0.6881294839906363 7.383655857978733e-07 -0.08940905707000608 +0.9492 0.6881356897030626 0.6881350106753319 7.442434485360749e-07 -0.08941210407217477 +0.9493 0.6881412313524122 0.6881405357524911 7.499481554790188e-07 -0.08941515024671456 +0.9494000000000001 0.6881467715120753 0.6881460592243307 7.554784962754413e-07 -0.08941819559382204 +0.9495 0.6881523101806117 0.6881515810930803 7.608332990294286e-07 -0.08942124011369376 +0.9496 0.6881578473565692 0.6881571013609808 7.660114302449061e-07 -0.0894242838065264 +0.9497000000000001 0.6881633830384835 0.6881626200302848 7.710117954501383e-07 -0.08942732667251635 +0.9498000000000001 0.6881689172248796 0.6881681371032558 7.758333392532402e-07 -0.08943036871186019 +0.9499000000000001 0.6881744499142715 0.6881736525821676 7.804750454531995e-07 -0.08943340992475433 +0.95 0.6881799811051632 0.6881791664693047 7.849359373868214e-07 -0.08943645031139523 +0.9501000000000001 0.6881855107960486 0.688184678766961 7.892150782062846e-07 -0.0894394898719793 +0.9502 0.688191038985412 0.6881901894774397 7.933115708791405e-07 -0.08944252860670289 +0.9503 0.6881965656717286 0.6881956986030529 7.972245585491367e-07 -0.0894455665157623 +0.9504000000000001 0.6882020908534654 0.6882012061461213 8.009532245500939e-07 -0.08944860359935386 +0.9505 0.6882076145290809 0.6882067121089741 8.044967928083624e-07 -0.08945163985767393 +0.9506 0.6882131366970258 0.6882122164939475 8.078545277317994e-07 -0.08945467529091872 +0.9507000000000001 0.6882186573557432 0.6882177193033847 8.110257346261029e-07 -0.08945770989928441 +0.9508000000000001 0.6882241765036696 0.6882232205396366 8.140097596115448e-07 -0.0894607436829672 +0.9509000000000001 0.6882296941392348 0.6882287202050597 8.16805989928282e-07 -0.08946377664216326 +0.951 0.6882352102608627 0.6882342183020169 8.194138539918683e-07 -0.0894668087770687 +0.9511000000000001 0.6882407248669713 0.6882397148328764 8.218328215459092e-07 -0.08946984008787971 +0.9512 0.6882462379559737 0.6882452098000111 8.240624036204292e-07 -0.08947287057479225 +0.9513 0.6882517495262778 0.6882507032057994 8.261021528926937e-07 -0.08947590023800239 +0.9514000000000001 0.6882572595762875 0.6882561950526231 8.279516635206763e-07 -0.08947892907770616 +0.9515 0.6882627681044025 0.6882616853428681 8.296105714483692e-07 -0.0894819570940995 +0.9516 0.688268275109019 0.6882671740789236 8.310785542531285e-07 -0.08948498428737836 +0.9517 0.6882737805885307 0.6882726612631814 8.323553314509846e-07 -0.08948801065773866 +0.9518000000000001 0.6882792845413281 0.6882781468980365 8.334406643439873e-07 -0.08949103620537631 +0.9519000000000001 0.6882847869658 0.688283630985885 8.343343561451055e-07 -0.08949406093048713 +0.952 0.6882902878603326 0.6882891135291247 8.350362520337384e-07 -0.08949708483326689 +0.9521000000000001 0.688295787223312 0.6882945945301555 8.355462391834712e-07 -0.08950010791391147 +0.9522 0.6883012850531225 0.6883000739913772 8.35864246678808e-07 -0.0895031301726166 +0.9523 0.6883067813481487 0.6883055519151897 8.35990245737217e-07 -0.08950615160957802 +0.9524000000000001 0.6883122761067748 0.688311028303993 8.359242495009633e-07 -0.08950917222499143 +0.9525 0.6883177693273858 0.6883165031601866 8.356663130648645e-07 -0.0895121920190525 +0.9526 0.6883232610083667 0.6883219764861688 8.35216533517924e-07 -0.08951521099195683 +0.9527 0.6883287511481049 0.6883274482843362 8.345750498878202e-07 -0.08951822914390006 +0.9528000000000001 0.6883342397449894 0.6883329185570837 8.337420431409059e-07 -0.08952124647507781 +0.9529000000000001 0.6883397267974112 0.688338387306804 8.327177360434312e-07 -0.08952426298568557 +0.953 0.6883452123037636 0.6883438545358862 8.315023931615428e-07 -0.08952727867591885 +0.9531000000000001 0.6883506962624435 0.6883493202467172 8.30096320819651e-07 -0.08953029354597312 +0.9532 0.6883561786718515 0.68835478444168 8.28499867072674e-07 -0.08953330759604394 +0.9533 0.6883616595303912 0.6883602471231521 8.26713421372971e-07 -0.08953632082632657 +0.9534000000000001 0.6883671388364719 0.6883657082935086 8.247374147923869e-07 -0.08953933323701652 +0.9535 0.6883726165885069 0.6883711679551183 8.225723196475521e-07 -0.08954234482830914 +0.9536 0.6883780927849151 0.6883766261103444 8.202186497496822e-07 -0.08954535560039976 +0.9537 0.688383567424121 0.6883820827615452 8.176769598633449e-07 -0.0895483655534837 +0.9538000000000001 0.6883890405045547 0.6883875379110718 8.149478457897263e-07 -0.08955137468775615 +0.9539000000000001 0.6883945120246542 0.6883929915612694 8.120319442417312e-07 -0.08955438300341248 +0.954 0.6883999819828627 0.6883984437144752 8.089299327329602e-07 -0.08955739050064777 +0.9541000000000001 0.6884054503776323 0.6884038943730195 8.056425292862768e-07 -0.0895603971796573 +0.9542 0.6884109172074223 0.6884093435392242 8.021704923227846e-07 -0.08956340304063615 +0.9543 0.6884163824707 0.6884147912154033 7.985146205508054e-07 -0.08956640808377944 +0.9544000000000001 0.6884218461659419 0.6884202374038615 7.946757527299564e-07 -0.08956941230928227 +0.9545 0.6884273082916335 0.6884256821068943 7.906547674768616e-07 -0.0895724157173397 +0.9546 0.6884327688462692 0.6884311253267881 7.864525830708624e-07 -0.08957541830814685 +0.9547 0.6884382278283543 0.6884365670658186 7.82070157245851e-07 -0.08957842008189856 +0.9548000000000001 0.6884436852364034 0.6884420073262512 7.775084870514926e-07 -0.08958142103878987 +0.9549000000000001 0.6884491410689426 0.6884474461103404 7.727686084646468e-07 -0.08958442117901572 +0.955 0.6884545953245087 0.6884528834203293 7.678515963061017e-07 -0.08958742050277096 +0.9551000000000001 0.6884600480016501 0.6884583192584498 7.627585638658729e-07 -0.08959041901025049 +0.9552 0.6884654990989276 0.6884637536269214 7.574906628060596e-07 -0.08959341670164918 +0.9553 0.6884709486149135 0.6884691865279507 7.520490827583881e-07 -0.08959641357716183 +0.9554000000000001 0.6884763965481938 0.688474617963732 7.464350512964568e-07 -0.0895994096369832 +0.9555 0.6884818428973668 0.6884800479364459 7.406498332140909e-07 -0.08960240488130805 +0.9556 0.6884872876610448 0.6884854764482597 7.346947306641205e-07 -0.08960539931033111 +0.9557 0.6884927308378537 0.6884909035013265 7.285710827004133e-07 -0.08960839292424704 +0.9558000000000001 0.6884981724264339 0.6884963290977848 7.222802650419524e-07 -0.0896113857232505 +0.9559000000000001 0.6885036124254404 0.6885017532397582 7.158236895732362e-07 -0.08961437770753614 +0.956 0.6885090508335434 0.6885071759293555 7.092028042748888e-07 -0.08961736887729856 +0.9561000000000001 0.6885144876494285 0.6885125971686699 7.024190928073271e-07 -0.08962035923273232 +0.9562 0.6885199228717966 0.688518016959778 6.954740741776932e-07 -0.08962334877403194 +0.9563 0.6885253564993651 0.6885234353047408 6.883693023096438e-07 -0.08962633750139189 +0.9564000000000001 0.6885307885308682 0.6885288522056024 6.811063658351824e-07 -0.08962932541500672 +0.9565 0.6885362189650568 0.68853426766439 6.736868876644486e-07 -0.08963231251507085 +0.9566 0.6885416478006985 0.6885396816831131 6.661125246387734e-07 -0.08963529880177866 +0.9567 0.6885470750365792 0.6885450942637634 6.583849672808784e-07 -0.08963828427532453 +0.9568000000000001 0.6885525006715023 0.6885505054083149 6.505059391426204e-07 -0.0896412689359028 +0.9569000000000001 0.68855792470429 0.688555915118723 6.424771966107024e-07 -0.08964425278370784 +0.957 0.6885633471337822 0.6885613233969243 6.34300528629117e-07 -0.08964723581893386 +0.9571000000000001 0.6885687679588387 0.6885667302448364 6.259777559636248e-07 -0.0896502180417752 +0.9572 0.6885741871783382 0.6885721356643576 6.175107311323647e-07 -0.08965319945242607 +0.9573 0.6885796047911787 0.6885775396573659 6.089013378368646e-07 -0.08965618005108067 +0.9574000000000001 0.6885850207962787 0.6885829422257195 6.001514905457084e-07 -0.08965915983793311 +0.9575 0.6885904351925765 0.6885883433712565 5.912631341337127e-07 -0.08966213881317757 +0.9576 0.6885958479790311 0.6885937430957938 5.822382432990603e-07 -0.08966511697700812 +0.9577 0.6886012591546221 0.6885991414011274 5.730788223690109e-07 -0.08966809432961882 +0.9578000000000001 0.6886066687183512 0.688604538289032 5.637869046198896e-07 -0.08967107087120374 +0.9579000000000001 0.6886120766692405 0.6886099337612612 5.543645519162643e-07 -0.08967404660195691 +0.958 0.6886174830063345 0.6886153278195457 5.448138543778791e-07 -0.08967702152207226 +0.9581000000000001 0.6886228877286996 0.6886207204655947 5.351369297551534e-07 -0.08967999563174378 +0.9582 0.6886282908354244 0.6886261117010947 5.253359229434595e-07 -0.0896829689311654 +0.9583 0.6886336923256204 0.6886315015277092 5.154130056639339e-07 -0.08968594142053096 +0.9584000000000001 0.6886390921984218 0.688636889947079 5.053703758112205e-07 -0.08968891310003434 +0.9585 0.688644490452986 0.6886422769608215 4.952102571065264e-07 -0.08969188396986938 +0.9586 0.6886498870884936 0.68864766257053 4.849348985702662e-07 -0.08969485403022981 +0.9587 0.6886552821041496 0.688653046777775 4.745465738975607e-07 -0.08969782328130949 +0.9588000000000001 0.6886606754991822 0.6886584295841016 4.640475812361933e-07 -0.08970079172330203 +0.9589000000000001 0.6886660672728442 0.6886638109910315 4.534402423123085e-07 -0.08970375935640124 +0.959 0.6886714574244128 0.6886691910000615 4.4272690225000133e-07 -0.08970672618080078 +0.9591000000000001 0.6886768459531899 0.6886745696126634 4.3190992884967194e-07 -0.08970969219669422 +0.9592 0.688682232858502 0.6886799468302842 4.209917121647533e-07 -0.08971265740427524 +0.9593 0.6886876181397013 0.6886853226543455 4.099746638772106e-07 -0.08971562180373735 +0.9594000000000001 0.6886930017961648 0.6886906970862431 3.988612169020245e-07 -0.08971858539527415 +0.9595 0.6886983838272956 0.6886960701273479 3.876538247696293e-07 -0.08972154817907918 +0.9596 0.688703764232522 0.6887014417790038 3.763549610638628e-07 -0.08972451015534583 +0.9597 0.688709143011299 0.6887068120425291 3.6496711885297684e-07 -0.08972747132426767 +0.9598000000000001 0.6887145201631073 0.6887121809192156 3.5349281033575375e-07 -0.089730431686038 +0.9599000000000001 0.6887198956874541 0.6887175484103288 3.419345660227169e-07 -0.08973339124085032 +0.96 0.6887252695838729 0.6887229145171074 3.3029493431285806e-07 -0.08973634998889794 +0.9601000000000001 0.6887306418519248 0.6887282792407627 3.1857648096628166e-07 -0.08973930793037421 +0.9602 0.6887360124911968 0.6887336425824797 3.067817884450097e-07 -0.08974226506547239 +0.9603 0.6887413815013038 0.6887390045434154 2.949134554550148e-07 -0.0897452213943858 +0.9604000000000001 0.6887467488818877 0.6887443651246996 2.8297409624539194e-07 -0.08974817691730766 +0.9605 0.6887521146326177 0.6887497243274346 2.709663401226359e-07 -0.08975113163443113 +0.9606 0.6887574787531905 0.6887550821526953 2.5889283085389625e-07 -0.08975408554594945 +0.9607 0.6887628412433309 0.6887604386015281 2.4675622606329384e-07 -0.08975703865205571 +0.9608000000000001 0.6887682021027913 0.6887657936749519 2.345591966906868e-07 -0.08975999095294307 +0.9609000000000001 0.6887735613313521 0.6887711473739571 2.223044263602314e-07 -0.08976294244880455 +0.961 0.6887789189288218 0.6887764996995058 2.0999461077669812e-07 -0.08976589313983327 +0.9611000000000001 0.6887842748950377 0.6887818506525321 1.9763245721893252e-07 -0.0897688430262222 +0.9612 0.6887896292298645 0.688787200233941 1.8522068386331303e-07 -0.0897717921081644 +0.9613 0.688794981933196 0.6887925484446096 1.7276201919394496e-07 -0.08977474038585274 +0.9614000000000001 0.6888003330049545 0.6887978952853857 1.6025920144407957e-07 -0.08977768785948022 +0.9615 0.6888056824450908 0.6888032407570881 1.4771497796814415e-07 -0.08978063452923968 +0.9616 0.6888110302535848 0.6888085848605076 1.3513210462071101e-07 -0.08978358039532407 +0.9617 0.6888163764304449 0.6888139275964048 1.2251334521873325e-07 -0.08978652545792612 +0.9618000000000001 0.6888217209757086 0.6888192689655122 1.0986147083377751e-07 -0.0897894697172387 +0.9619000000000001 0.6888270638894423 0.6888246089685326 9.717925928548476e-08 -0.08979241317345454 +0.962 0.6888324051717412 0.68882994760614 8.446949444074203e-08 -0.08979535582676645 +0.9621000000000001 0.6888377448227301 0.6888352848789787 7.173496567591808e-08 -0.08979829767736702 +0.9622 0.6888430828425627 0.6888406207876643 5.897846722460742e-08 -0.08980123872544907 +0.9623 0.6888484192314219 0.6888459553327821 4.620279758088541e-08 -0.08980417897120514 +0.9624000000000001 0.6888537539895202 0.688851288514889 3.3410758876542546e-08 -0.08980711841482791 +0.9625 0.6888590871170988 0.6888566203345116 2.0605156263522884e-08 -0.08981005705650992 +0.9626 0.6888644186144285 0.6888619507921474 7.788797317179186e-09 -0.08981299489644376 +0.9627 0.6888697484818096 0.6888672798882649 -5.035508599503247e-09 -0.08981593193482197 +0.9628000000000001 0.6888750767195716 0.6888726076233024 -1.786495093872298e-08 -0.08981886817183701 +0.9629000000000001 0.6888804033280731 0.688877933997669 -3.069671859106185e-08 -0.08982180360768138 +0.963 0.6888857283077023 0.6888832590117439 -4.352800049654132e-08 -0.08982473824254744 +0.9631000000000001 0.6888910516588765 0.6888885826658773 -5.635598626793029e-08 -0.08982767207662758 +0.9632000000000001 0.688896373382043 0.68889390496039 -6.917786679692256e-08 -0.08983060511011429 +0.9633 0.6889016934776775 0.6888992258955731 -8.199083487581832e-08 -0.08983353734319978 +0.9634000000000001 0.6889070119462853 0.6889045454716883 -9.479208581183313e-08 -0.08983646877607644 +0.9635 0.6889123287884016 0.6889098636889677 -1.0757881803089009e-07 -0.08983939940893652 +0.9636 0.6889176440045898 0.6889151805476141 -1.2034823371025183e-07 -0.08984232924197222 +0.9637 0.6889229575954431 0.6889204960478011 -1.3309753937526536e-07 -0.08984525827537582 +0.9638000000000001 0.6889282695615837 0.6889258101896734 -1.4582394651171948e-07 -0.08984818650933947 +0.9639000000000001 0.6889335799036627 0.6889311229733457 -1.585246721929473e-07 -0.08985111394405533 +0.964 0.6889388886223602 0.6889364343989042 -1.7119693966269334e-07 -0.08985404057971555 +0.9641000000000001 0.6889441957183854 0.6889417444664054 -1.8383797896134868e-07 -0.08985696641651211 +0.9642000000000001 0.6889495011924762 0.6889470531758776 -1.96445027515757e-07 -0.08985989145463717 +0.9643 0.6889548050453995 0.6889523605273196 -2.090153307619802e-07 -0.08986281569428273 +0.9644000000000001 0.6889601072779505 0.6889576665207013 -2.2154614273683926e-07 -0.08986573913564078 +0.9645 0.6889654078909533 0.6889629711559644 -2.340347266850673e-07 -0.08986866177890329 +0.9646 0.6889707068852602 0.6889682744330216 -2.4647835563870735e-07 -0.08987158362426217 +0.9647 0.6889760042617521 0.688973576351757 -2.588743130277349e-07 -0.08987450467190938 +0.9648000000000001 0.6889813000213381 0.6889788769120265 -2.7121989328374174e-07 -0.08987742492203675 +0.9649000000000001 0.6889865941649553 0.6889841761136575 -2.8351240241586417e-07 -0.08988034437483611 +0.965 0.688991886693569 0.6889894739564497 -2.9574915859365003e-07 -0.08988326303049925 +0.9651000000000001 0.6889971776081723 0.6889947704401742 -3.0792749275421194e-07 -0.08988618088921801 +0.9652000000000001 0.6890024669097856 0.6890000655645746 -3.200447491399916e-07 -0.08988909795118409 +0.9653 0.6890077545994578 0.6890053593293666 -3.320982859544852e-07 -0.08989201421658921 +0.9654 0.6890130406782646 0.689010651734238 -3.440854758757217e-07 -0.08989492968562508 +0.9655 0.689018325147309 0.6890159427788501 -3.560037066460686e-07 -0.08989784435848336 +0.9656 0.6890236080077212 0.689021232462836 -3.6785038162734374e-07 -0.08990075823535561 +0.9657 0.6890288892606584 0.689026520785802 -3.7962292041143764e-07 -0.08990367131643345 +0.9658000000000001 0.6890341689073047 0.6890318077473273 -3.913187593476697e-07 -0.08990658360190845 +0.9659000000000001 0.6890394469488703 0.689037093346965 -4.0293535207708286e-07 -0.08990949509197212 +0.966 0.6890447233865924 0.6890423775842409 -4.144701701500053e-07 -0.08991240578681599 +0.9661000000000001 0.6890499982217342 0.6890476604586546 -4.2592070356034517e-07 -0.08991531568663151 +0.9662000000000001 0.6890552714555844 0.6890529419696799 -4.372844612590687e-07 -0.08991822479161007 +0.9663 0.6890605430894585 0.6890582221167644 -4.4855897168155634e-07 -0.08992113310194316 +0.9664 0.689065813124697 0.6890635008993296 -4.597417833859807e-07 -0.08992404061782205 +0.9665 0.6890710815626655 0.689068778316772 -4.7083046546964047e-07 -0.08992694733943817 +0.9666 0.6890763484047555 0.6890740543684625 -4.81822608172644e-07 -0.08992985326698275 +0.9667 0.689081613652383 0.689079329053747 -4.927158233705708e-07 -0.08993275840064713 +0.9668000000000001 0.6890868773069887 0.6890846023719466 -5.035077451087666e-07 -0.08993566274062254 +0.9669000000000001 0.6890921393700378 0.6890898743223579 -5.141960301088822e-07 -0.08993856628710024 +0.967 0.6890973998430197 0.6890951449042522 -5.247783582823518e-07 -0.08994146904027128 +0.9671000000000001 0.689102658727448 0.6891004141168777 -5.352524332230546e-07 -0.08994437100032697 +0.9672000000000001 0.68910791602486 0.6891056819594588 -5.456159827277318e-07 -0.08994727216745838 +0.9673 0.689113171736816 0.6891109484311951 -5.558667592470146e-07 -0.08995017254185653 +0.9674 0.6891184258648999 0.689116213531264 -5.660025404197189e-07 -0.0899530721237125 +0.9675 0.6891236784107188 0.6891214772588192 -5.760211296002016e-07 -0.08995597091321733 +0.9676 0.689128929375902 0.6891267396129921 -5.859203561914272e-07 -0.0899588689105621 +0.9677 0.6891341787621013 0.6891320005928909 -5.956980762139574e-07 -0.08996176611593767 +0.9678000000000001 0.6891394265709906 0.689137260197602 -6.053521727361622e-07 -0.08996466252953504 +0.9679000000000001 0.689144672804266 0.6891425184261899 -6.148805564709647e-07 -0.08996755815154511 +0.968 0.689149917463644 0.6891477752776967 -6.242811660117642e-07 -0.08997045298215867 +0.9681000000000001 0.6891551605508641 0.6891530307511441 -6.335519683459134e-07 -0.08997334702156667 +0.9682000000000001 0.6891604020676854 0.689158284845532 -6.426909594098307e-07 -0.08997624026995987 +0.9683 0.6891656420158878 0.6891635375598398 -6.516961643943109e-07 -0.08997913272752903 +0.9684 0.6891708803972714 0.6891687888930264 -6.605656382718816e-07 -0.08998202439446486 +0.9685 0.6891761172136572 0.6891740388440305 -6.692974660466033e-07 -0.08998491527095814 +0.9686 0.6891813524668846 0.6891792874117713 -6.778897634618364e-07 -0.08998780535719954 +0.9687 0.6891865861588136 0.6891845345951482 -6.863406770696301e-07 -0.08999069465337976 +0.9688000000000001 0.6891918182913221 0.6891897803930411 -6.946483848552232e-07 -0.08999358315968929 +0.9689000000000001 0.6891970488663077 0.6891950248043118 -7.028110966394996e-07 -0.0899964708763189 +0.969 0.6892022778856854 0.6892002678278031 -7.10827054245522e-07 -0.08999935780345901 +0.9691000000000001 0.6892075053513889 0.6892055094623397 -7.186945321507876e-07 -0.09000224394130021 +0.9692000000000001 0.6892127312653691 0.6892107497067286 -7.264118377925399e-07 -0.09000512929003296 +0.9693 0.6892179556295945 0.6892159885597589 -7.339773116787907e-07 -0.09000801384984772 +0.9694 0.6892231784460507 0.6892212260202033 -7.413893280266981e-07 -0.09001089762093496 +0.9695 0.6892283997167399 0.6892264620868171 -7.486462951233896e-07 -0.09001378060348508 +0.9696 0.6892336194436798 0.6892316967583397 -7.557466555202508e-07 -0.09001666279768844 +0.9697 0.6892388376289048 0.6892369300334938 -7.626888863937475e-07 -0.09001954420373535 +0.9698000000000001 0.6892440542744649 0.6892421619109874 -7.694714999062491e-07 -0.09002242482181617 +0.9699000000000001 0.6892492693824245 0.689247392389512 -7.760930435529723e-07 -0.09002530465212114 +0.97 0.6892544829548635 0.689252621467745 -7.825521004117819e-07 -0.0900281836948405 +0.9701000000000001 0.6892596949938756 0.6892578491443491 -7.888472895317689e-07 -0.09003106195016447 +0.9702000000000001 0.6892649055015689 0.6892630754179725 -7.949772661275389e-07 -0.0900339394182832 +0.9703 0.6892701144800656 0.6892683002872502 -8.009407218984022e-07 -0.09003681609938692 +0.9704 0.6892753219315004 0.6892735237508032 -8.067363854308285e-07 -0.09003969199366575 +0.9705 0.6892805278580213 0.6892787458072396 -8.123630222400813e-07 -0.09004256710130976 +0.9706 0.6892857322617882 0.689283966455155 -8.17819435242062e-07 -0.09004544142250893 +0.9707 0.6892909351449739 0.6892891856931327 -8.231044648782104e-07 -0.09004831495745337 +0.9708000000000001 0.6892961365097623 0.6892944035197442 -8.282169894346936e-07 -0.09005118770633305 +0.9709000000000001 0.6893013363583488 0.6892996199335494 -8.331559252505727e-07 -0.09005405966933792 +0.971 0.6893065346929398 0.6893048349330972 -8.379202270092367e-07 -0.09005693084665795 +0.9711000000000001 0.689311731515752 0.6893100485169259 -8.425088878494247e-07 -0.09005980123848295 +0.9712000000000001 0.689316926829012 0.6893152606835639 -8.469209396427813e-07 -0.09006267084500286 +0.9713 0.6893221206349569 0.689320471431529 -8.51155453188146e-07 -0.09006553966640754 +0.9714 0.6893273129358323 0.6893256807593302 -8.552115384613534e-07 -0.09006840770288677 +0.9715 0.6893325037338925 0.6893308886654671 -8.590883446707442e-07 -0.09007127495463024 +0.9716 0.6893376930314008 0.6893360951484313 -8.627850606179877e-07 -0.09007414142182779 +0.9717 0.6893428808306287 0.6893413002067055 -8.66300914670326e-07 -0.09007700710466911 +0.9718000000000001 0.6893480671338544 0.6893465038387651 -8.696351751075193e-07 -0.0900798720033439 +0.9719000000000001 0.6893532519433645 0.689351706043078 -8.727871502051121e-07 -0.09008273611804181 +0.972 0.6893584352614511 0.6893569068181051 -8.757561882760667e-07 -0.09008559944895245 +0.9721000000000001 0.6893636170904134 0.6893621061623009 -8.785416779205635e-07 -0.09008846199626531 +0.9722000000000001 0.6893687974325565 0.6893673040741137 -8.811430481786564e-07 -0.09009132376017008 +0.9723 0.6893739762901909 0.6893725005519864 -8.835597685719065e-07 -0.09009418474085623 +0.9724 0.6893791536656322 0.6893776955943566 -8.857913492144043e-07 -0.09009704493851325 +0.9725 0.6893843295612005 0.6893828891996565 -8.878373409237916e-07 -0.09009990435333058 +0.9726 0.6893895039792202 0.6893880813663151 -8.896973354155513e-07 -0.09010276298549771 +0.9727 0.6893946769220196 0.6893932720927562 -8.913709651364732e-07 -0.09010562083520397 +0.9728000000000001 0.6893998483919304 0.6893984613774009 -8.928579036671103e-07 -0.09010847790263878 +0.9729000000000001 0.6894050183912869 0.6894036492186668 -8.941578655274895e-07 -0.09011133418799144 +0.973 0.6894101869224262 0.689408835614969 -8.95270606246501e-07 -0.0901141896914512 +0.9731000000000001 0.6894153539876877 0.6894140205647206 -8.9619592259782e-07 -0.09011704441320745 +0.9732000000000001 0.6894205195894118 0.6894192040663323 -8.969336524333738e-07 -0.0901198983534493 +0.9733 0.6894256837299407 0.6894243861182143 -8.974836748498749e-07 -0.09012275151236612 +0.9734 0.6894308464116171 0.6894295667187751 -8.978459100777991e-07 -0.09012560389014697 +0.9735 0.689436007636784 0.6894347458664227 -8.980203197034298e-07 -0.09012845548698098 +0.9736 0.6894411674077844 0.6894399235595654 -8.980069064190577e-07 -0.09013130630305731 +0.9737 0.689446325726961 0.689445099796612 -8.978057141340035e-07 -0.09013415633856503 +0.9738000000000001 0.6894514825966551 0.6894502745759714 -8.97416827946862e-07 -0.0901370055936932 +0.9739000000000001 0.6894566380192075 0.6894554478960547 -8.968403742287689e-07 -0.0901398540686309 +0.974 0.6894617919969561 0.6894606197552738 -8.960765203597232e-07 -0.09014270176356702 +0.9741000000000001 0.689466944532237 0.689465790152043 -8.951254748534865e-07 -0.09014554867869057 +0.9742000000000001 0.6894720956273838 0.6894709590847792 -8.939874872881948e-07 -0.09014839481419046 +0.9743 0.6894772452847266 0.6894761265519018 -8.926628480843135e-07 -0.09015124017025555 +0.9744 0.6894823935065926 0.6894812925518342 -8.911518887544378e-07 -0.09015408474707473 +0.9745 0.6894875402953047 0.6894864570830033 -8.894549815008368e-07 -0.09015692854483684 +0.9746 0.6894926856531812 0.6894916201438404 -8.87572539229331e-07 -0.0901597715637307 +0.9747 0.6894978295825358 0.6894967817327808 -8.855050155909261e-07 -0.09016261380394501 +0.9748000000000001 0.6895029720856771 0.6895019418482656 -8.83252904704257e-07 -0.09016545526566855 +0.9749000000000001 0.6895081131649081 0.6895071004887413 -8.808167410584433e-07 -0.09016829594909001 +0.975 0.6895132528225253 0.6895122576526602 -8.781970994575783e-07 -0.0901711358543981 +0.9751000000000001 0.6895183910608189 0.6895174133384807 -8.753945949097064e-07 -0.09017397498178141 +0.9752000000000001 0.6895235278820724 0.6895225675446683 -8.724098823353899e-07 -0.09017681333142857 +0.9753000000000001 0.6895286632885615 0.6895277202696958 -8.692436566509754e-07 -0.09017965090352817 +0.9754 0.6895337972825548 0.689532871512043 -8.658966522967493e-07 -0.09018248769826875 +0.9755 0.689538929866312 0.6895380212701985 -8.623696433063266e-07 -0.09018532371583882 +0.9756 0.6895440610420851 0.6895431695426584 -8.586634430846063e-07 -0.09018815895642686 +0.9757 0.6895491908121163 0.6895483163279286 -8.547789041579712e-07 -0.09019099342022135 +0.9758000000000001 0.6895543191786389 0.6895534616245234 -8.507169181187768e-07 -0.09019382710741068 +0.9759000000000001 0.6895594461438759 0.689558605430967 -8.464784151951399e-07 -0.09019666001818322 +0.976 0.6895645717100407 0.6895637477457943 -8.42064364278694e-07 -0.09019949215272738 +0.9761 0.6895696958793356 0.6895688885675499 -8.374757725498894e-07 -0.09020232351123142 +0.9762000000000001 0.6895748186539521 0.6895740278947894 -8.327136852975814e-07 -0.09020515409388369 +0.9763000000000001 0.6895799400360705 0.6895791657260799 -8.277791856275973e-07 -0.09020798390087248 +0.9764 0.6895850600278591 0.6895843020599998 -8.226733943517139e-07 -0.09021081293238596 +0.9765 0.6895901786314736 0.6895894368951394 -8.173974696407127e-07 -0.09021364118861228 +0.9766 0.6895952958490581 0.6895945702301023 -8.119526067190685e-07 -0.0902164686697397 +0.9767 0.6896004116827427 0.6895997020635041 -8.063400376429053e-07 -0.09021929537595637 +0.9768000000000001 0.6896055261346448 0.689604832393974 -8.005610311612177e-07 -0.09022212130745033 +0.9769000000000001 0.6896106392068675 0.6896099612201543 -7.946168922023933e-07 -0.09022494646440964 +0.977 0.6896157509015007 0.6896150885407019 -7.88508961707679e-07 -0.09022777084702244 +0.9771 0.689620861220619 0.6896202143542877 -7.822386162287254e-07 -0.09023059445547665 +0.9772000000000001 0.6896259701662824 0.689625338659597 -7.758072678026862e-07 -0.09023341728996026 +0.9773000000000001 0.6896310777405357 0.6896304614553305 -7.692163634526183e-07 -0.09023623935066122 +0.9774 0.6896361839454082 0.6896355827402046 -7.624673849099262e-07 -0.09023906063776746 +0.9775 0.6896412887829131 0.689640702512951 -7.555618484617055e-07 -0.09024188115146686 +0.9776 0.6896463922550473 0.6896458207723174 -7.485013042568545e-07 -0.09024470089194724 +0.9777 0.6896514943637915 0.6896509375170689 -7.412873362366845e-07 -0.09024751985939646 +0.9778000000000001 0.6896565951111087 0.6896560527459866 -7.339215617879757e-07 -0.09025033805400232 +0.9779000000000001 0.6896616944989451 0.6896611664578692 -7.264056311878653e-07 -0.09025315547595256 +0.978 0.6896667925292287 0.689666278651533 -7.187412273262916e-07 -0.09025597212543494 +0.9781 0.6896718892038698 0.6896713893258114 -7.109300654978279e-07 -0.09025878800263704 +0.9782000000000001 0.6896769845247603 0.6896764984795571 -7.029738927077922e-07 -0.09026160310774664 +0.9783000000000001 0.6896820784937732 0.6896816061116406 -6.948744875612256e-07 -0.0902644174409513 +0.9784 0.6896871711127628 0.6896867122209518 -6.866336596245137e-07 -0.09026723100243864 +0.9785 0.689692262383564 0.6896918168063995 -6.782532492866089e-07 -0.09027004379239624 +0.9786 0.6896973523079917 0.6896969198669116 -6.69735127120652e-07 -0.09027285581101163 +0.9787 0.6897024408878412 0.6897020214014367 -6.610811935786609e-07 -0.09027566705847231 +0.9788000000000001 0.6897075281248876 0.6897071214089431 -6.522933784780527e-07 -0.09027847753496582 +0.9789000000000001 0.6897126140208847 0.6897122198884192 -6.433736408073543e-07 -0.09028128724067949 +0.979 0.6897176985775662 0.6897173168388747 -6.343239679490464e-07 -0.09028409617580077 +0.9791 0.6897227817966438 0.6897224122593397 -6.251463755546638e-07 -0.09028690434051696 +0.9792000000000001 0.6897278636798088 0.6897275061488666 -6.15842906864783e-07 -0.09028971173501556 +0.9793000000000001 0.6897329442287301 0.6897325985065283 -6.064156323065673e-07 -0.0902925183594838 +0.9794 0.6897380234450545 0.6897376893314204 -5.968666491468211e-07 -0.09029532421410896 +0.9795 0.6897431013304067 0.6897427786226604 -5.871980810062682e-07 -0.09029812929907832 +0.9796 0.6897481778863884 0.6897478663793879 -5.774120772211733e-07 -0.09030093361457907 +0.9797 0.6897532531145791 0.6897529526007657 -5.67510812482519e-07 -0.0903037371607984 +0.9798000000000001 0.6897583270165348 0.6897580372859793 -5.574964863919174e-07 -0.09030653993792344 +0.9799000000000001 0.6897633995937882 0.6897631204342375 -5.473713229620092e-07 -0.09030934194614139 +0.98 0.6897684708478482 0.6897682020447725 -5.37137570019719e-07 -0.0903121431856393 +0.9801 0.6897735407801999 0.6897732821168401 -5.267974988454327e-07 -0.09031494365660415 +0.9802000000000001 0.6897786093923046 0.6897783606497205 -5.163534035831918e-07 -0.0903177433592231 +0.9803000000000001 0.6897836766855991 0.6897834376427177 -5.058076006786427e-07 -0.09032054229368308 +0.9804 0.6897887426614955 0.68978851309516 -4.951624285043366e-07 -0.09032334046017107 +0.9805 0.689793807321381 0.6897935870064009 -4.844202468115566e-07 -0.09032613785887399 +0.9806 0.689798870666618 0.6897986593758182 -4.7358343613357334e-07 -0.09032893448997875 +0.9807 0.6898039326985437 0.689803730202815 -4.6265439732767755e-07 -0.09033173035367222 +0.9808000000000001 0.6898089934184699 0.6898087994868198 -4.5163555097843533e-07 -0.09033452545014124 +0.9809000000000001 0.6898140528276822 0.6898138672272865 -4.4052933696053787e-07 -0.0903373197795726 +0.981 0.6898191109274412 0.6898189334236946 -4.2933821376572867e-07 -0.09034011334215311 +0.9811 0.6898241677189809 0.6898239980755494 -4.1806465810034776e-07 -0.09034290613806945 +0.9812000000000001 0.6898292232035095 0.6898290611823823 -4.0671116418450337e-07 -0.0903456981675084 +0.9813000000000001 0.6898342773822081 0.6898341227437514 -3.9528024337737167e-07 -0.09034848943065663 +0.9814 0.6898393302562321 0.6898391827592407 -3.8377442348330737e-07 -0.09035127992770076 +0.9815 0.6898443818267095 0.6898442412284607 -3.721962482522434e-07 -0.09035406965882738 +0.9816 0.6898494320947421 0.6898492981510487 -3.6054827681070156e-07 -0.09035685862422314 +0.9817 0.6898544810614042 0.6898543535266697 -3.488330830511699e-07 -0.0903596468240746 +0.9818000000000001 0.6898595287277426 0.6898594073550142 -3.3705325516025786e-07 -0.0903624342585682 +0.9819000000000001 0.6898645750947773 0.6898644596358012 -3.2521139495950147e-07 -0.09036522092789048 +0.982 0.6898696201635005 0.6898695103687766 -3.133101173849462e-07 -0.09036800683222787 +0.9821 0.6898746639348772 0.6898745595537137 -3.013520498695854e-07 -0.09037079197176683 +0.9822000000000001 0.6898797064098439 0.6898796071904136 -2.8933983179518785e-07 -0.09037357634669374 +0.9823000000000001 0.68988474758931 0.6898846532787049 -2.772761139094304e-07 -0.09037635995719495 +0.9824 0.6898897874741564 0.6898896978184437 -2.651635577256839e-07 -0.0903791428034568 +0.9825 0.6898948260652368 0.6898947408095146 -2.5300483489851255e-07 -0.09038192488566561 +0.9826 0.6898998633633755 0.68989978225183 -2.408026267101959e-07 -0.09038470620400761 +0.9827 0.6899048993693693 0.6899048221453303 -2.2855962348092285e-07 -0.09038748675866905 +0.9828000000000001 0.6899099340839865 0.6899098604899845 -2.162785238610243e-07 -0.09039026654983616 +0.9829000000000001 0.6899149675079669 0.6899148972857891 -2.039620343799453e-07 -0.09039304557769505 +0.983 0.6899199996420216 0.6899199325327701 -1.9161286877317218e-07 -0.09039582384243189 +0.9831 0.6899250304868336 0.6899249662309808 -1.7923374736120157e-07 -0.0903986013442328 +0.9832000000000001 0.6899300600430567 0.6899299983805036 -1.668273965534095e-07 -0.09040137808328384 +0.9833000000000001 0.6899350883113162 0.6899350289814496 -1.5439654812293702e-07 -0.09040415405977105 +0.9834 0.6899401152922089 0.6899400580339583 -1.4194393868453836e-07 -0.0904069292738805 +0.9835 0.6899451409863026 0.6899450855381974 -1.2947230907875418e-07 -0.09040970372579808 +0.9836 0.6899501653941361 0.6899501114943641 -1.1698440375608465e-07 -0.09041247741570982 +0.9837 0.6899551885162193 0.689955135902684 -1.0448297017157104e-07 -0.0904152503438016 +0.9838000000000001 0.6899602103530335 0.6899601587634111 -9.197075819759176e-08 -0.09041802251025927 +0.9839000000000001 0.6899652309050309 0.6899651800768287 -7.945051950109666e-08 -0.09042079391526875 +0.984 0.6899702501726348 0.6899701998432486 -6.692500695640313e-08 -0.09042356455901585 +0.9841 0.6899752681562392 0.6899752180630112 -5.439697401982829e-08 -0.0904263344416863 +0.9842000000000001 0.6899802848562101 0.6899802347364863 -4.1869174136630397e-08 -0.0904291035634659 +0.9843000000000001 0.6899853002728835 0.6899852498640718 -2.934436013808401e-08 -0.0904318719245404 +0.9844 0.6899903144065671 0.6899902634461949 -1.682528362944788e-08 -0.09043463952509545 +0.9845 0.6899953272575396 0.6899952754833109 -4.31469438736537e-09 -0.09043740636531669 +0.9846 0.6900003388260506 0.6900002859759047 8.184660242084585e-09 -0.09044017244538984 +0.9847 0.6900053491123208 0.690005294924489 2.0670035949348076e-08 -0.09044293776550036 +0.9848000000000001 0.6900103581165427 0.6900103023296065 3.3138692059550556e-08 -0.09044570232583399 +0.9849000000000001 0.6900153658388795 0.6900153081918268 4.558789213834902e-08 -0.09044846612657617 +0.985 0.6900203722794656 0.690020312511749 5.801490459561576e-08 -0.09045122916791241 +0.9851 0.6900253774384071 0.6900253152900007 7.041700328044853e-08 -0.09045399145002818 +0.9852000000000001 0.6900303813157813 0.690030316527238 8.279146807357862e-08 -0.0904567529731089 +0.9853000000000001 0.6900353839116369 0.690035316224145 9.513558549278933e-08 -0.09045951373734001 +0.9854 0.6900403852259944 0.6900403143814344 1.074466492931303e-07 -0.09046227374290688 +0.9855 0.6900453852588457 0.690045310999847 1.1972196103937627e-07 -0.09046503298999481 +0.9856 0.6900503840101548 0.690050306080152 1.319588307235886e-07 -0.09046779147878925 +0.9857 0.6900553814798568 0.6900552996231462 1.4415457734451298e-07 -0.09047054920947535 +0.9858000000000001 0.6900603776678593 0.6900602916296541 1.5630652948350754e-07 -0.09047330618223835 +0.9859000000000001 0.6900653725740418 0.6900652821005293 1.684120258943489e-07 -0.09047606239726355 +0.986 0.6900703661982556 0.6900702710366518 1.8046841611038533e-07 -0.09047881785473609 +0.9861 0.6900753585403245 0.6900752584389296 1.924730609961789e-07 -0.0904815725548411 +0.9862000000000001 0.6900803496000449 0.6900802443082984 2.0442333332343354e-07 -0.09048432649776371 +0.9863000000000001 0.6900853393771855 0.6900852286457211 2.1631661838161786e-07 -0.09048707968368902 +0.9864 0.6900903278714875 0.6900902114521881 2.281503145296071e-07 -0.09048983211280212 +0.9865 0.6900953150826652 0.690095192728716 2.3992183374038634e-07 -0.09049258378528802 +0.9866 0.6901003010104052 0.6901001724763494 2.5162860219779537e-07 -0.09049533470133164 +0.9867 0.6901052856543679 0.690105150696159 2.6326806084470133e-07 -0.09049808486111807 +0.9868000000000001 0.6901102690141867 0.6901101273892422 2.7483766598668247e-07 -0.09050083426483216 +0.9869000000000001 0.6901152510894683 0.6901151025567229 2.863348897708118e-07 -0.09050358291265881 +0.987 0.6901202318797929 0.6901200761997512 2.9775722078934086e-07 -0.09050633080478289 +0.9871 0.6901252113847146 0.6901250483195038 3.091021646486891e-07 -0.09050907794138927 +0.9872000000000001 0.6901301896037617 0.6901300189171824 3.2036724442047193e-07 -0.09051182432266269 +0.9873000000000001 0.6901351665364359 0.6901349879940148 3.3155000130763446e-07 -0.09051456994878793 +0.9874 0.6901401421822142 0.6901399555512548 3.426479950954797e-07 -0.09051731481994979 +0.9875 0.6901451165405477 0.6901449215901809 3.536588047206579e-07 -0.09052005893633296 +0.9876 0.6901500896108614 0.6901498861120969 3.6458002879158347e-07 -0.090522802298122 +0.9877 0.6901550613925567 0.6901548491183316 3.7540928608803537e-07 -0.09052554490550169 +0.9878000000000001 0.6901600318850093 0.6901598106102383 3.8614421608157423e-07 -0.09052828675865661 +0.9879000000000001 0.6901650010875703 0.6901647705891949 3.9678247954616497e-07 -0.09053102785777128 +0.988 0.6901699689995668 0.6901697290566038 4.073217589536937e-07 -0.09053376820303034 +0.9881 0.6901749356203013 0.6901746860138905 4.1775975901520157e-07 -0.0905365077946182 +0.9882000000000001 0.6901799009490526 0.6901796414625055 4.2809420720824054e-07 -0.09053924663271945 +0.9883000000000001 0.6901848649850757 0.6901845954039219 4.383228542279016e-07 -0.0905419847175184 +0.9884000000000001 0.6901898277276024 0.6901895478396364 4.484434744933541e-07 -0.09054472204919957 +0.9885 0.6901947891758411 0.6901944987711689 4.5845386670295696e-07 -0.09054745862794736 +0.9886 0.6901997493289779 0.6901994482000616 4.683518541187537e-07 -0.09055019445394612 +0.9887 0.690204708186175 0.6902043961278795 4.78135285295056e-07 -0.09055292952738009 +0.9888000000000001 0.6902096657465735 0.6902093425562101 4.878020343768164e-07 -0.09055566384843369 +0.9889000000000001 0.6902146220092916 0.690214287486662 4.973500016269838e-07 -0.09055839741729106 +0.989 0.6902195769734261 0.6902192309208666 5.067771138150823e-07 -0.09056113023413652 +0.9891 0.6902245306380517 0.6902241728604757 5.160813247584439e-07 -0.0905638622991542 +0.9892000000000001 0.6902294830022224 0.6902291133071627 5.252606157385431e-07 -0.09056659361252828 +0.9893000000000001 0.6902344340649711 0.690234052262622 5.343129958895743e-07 -0.09056932417444293 +0.9894000000000001 0.69023938382531 0.6902389897285679 5.432365026841746e-07 -0.09057205398508222 +0.9895 0.6902443322822307 0.6902439257067354 5.520292024191464e-07 -0.09057478304463017 +0.9896 0.690249279434705 0.6902488601988794 5.606891903681133e-07 -0.0905775113532709 +0.9897 0.6902542252816851 0.6902537932067742 5.692145916280644e-07 -0.09058023891118837 +0.9898 0.6902591698221032 0.6902587247322134 5.776035610638441e-07 -0.09058296571856654 +0.9899000000000001 0.6902641130548729 0.6902636547770096 5.858542841130632e-07 -0.09058569177558935 +0.99 0.6902690549788886 0.6902685833429941 5.9396497684161e-07 -0.0905884170824407 +0.9901 0.6902739955930266 0.6902735104320168 6.019338865959067e-07 -0.09059114163930454 +0.9902000000000001 0.6902789348961451 0.6902784360459451 6.097592921971984e-07 -0.09059386544636464 +0.9903000000000001 0.6902838728870841 0.6902833601866643 6.174395044550307e-07 -0.09059658850380486 +0.9904000000000001 0.6902888095646662 0.6902882828560768 6.249728664309284e-07 -0.09059931081180893 +0.9905 0.6902937449276971 0.6902932040561023 6.323577537853398e-07 -0.09060203237056062 +0.9906 0.6902986789749656 0.6902981237886769 6.395925752911147e-07 -0.09060475318024364 +0.9907 0.6903036117052439 0.6903030420557532 6.46675772958405e-07 -0.0906074732410417 +0.9908 0.6903085431172885 0.6903079588592995 6.536058224926311e-07 -0.09061019255313843 +0.9909000000000001 0.6903134732098399 0.6903128742012998 6.603812335997938e-07 -0.09061291111671746 +0.991 0.6903184019816233 0.6903177880837528 6.670005503334187e-07 -0.09061562893196232 +0.9911 0.690323329431349 0.6903227005086732 6.734623513998672e-07 -0.09061834599905665 +0.9912000000000001 0.6903282555577124 0.6903276114780892 6.797652503942597e-07 -0.09062106231818395 +0.9913000000000001 0.690333180359395 0.6903325209940432 6.85907896189053e-07 -0.09062377788952766 +0.9914000000000001 0.690338103835064 0.690337429058592 6.918889732115963e-07 -0.09062649271327135 +0.9915 0.6903430259833736 0.6903423356738049 6.977072016661756e-07 -0.09062920678959835 +0.9916 0.6903479468029641 0.6903472408417648 7.033613379087145e-07 -0.09063192011869209 +0.9917 0.6903528662924637 0.690352144564567 7.088501745994291e-07 -0.0906346327007359 +0.9918 0.6903577844504885 0.6903570468443188 7.141725409803845e-07 -0.09063734453591321 +0.9919000000000001 0.6903627012756415 0.6903619476831395 7.193273032363168e-07 -0.09064005562440719 +0.992 0.6903676167665149 0.6903668470831602 7.243133646611666e-07 -0.0906427659664012 +0.9921 0.6903725309216897 0.6903717450465228 7.291296658107349e-07 -0.09064547556207844 +0.9922000000000001 0.690377443739736 0.6903766415753794 7.337751848357499e-07 -0.09064818441162213 +0.9923000000000001 0.690382355219213 0.690381536671893 7.382489377871781e-07 -0.09065089251521541 +0.9924000000000001 0.6903872653586705 0.6903864303382359 7.425499785329581e-07 -0.0906535998730414 +0.9925 0.6903921741566488 0.6903913225765906 7.466773992437226e-07 -0.09065630648528328 +0.9926 0.6903970816116785 0.6903962133891481 7.506303305176987e-07 -0.09065901235212412 +0.9927 0.6904019877222811 0.6904011027781083 7.544079414084637e-07 -0.09066171747374689 +0.9928 0.6904068924869706 0.6904059907456791 7.580094398412784e-07 -0.09066442185033469 +0.9929000000000001 0.6904117959042524 0.6904108772940766 7.614340725298208e-07 -0.09066712548207043 +0.993 0.6904166979726247 0.6904157624255239 7.6468112532313e-07 -0.0906698283691371 +0.9931 0.6904215986905781 0.6904206461422515 7.677499233860186e-07 -0.09067253051171761 +0.9932000000000001 0.6904264980565965 0.6904255284464962 7.70639831032538e-07 -0.09067523190999478 +0.9933000000000001 0.6904313960691579 0.6904304093405015 7.733502522810909e-07 -0.09067793256415158 +0.9934000000000001 0.6904362927267336 0.690435288826516 7.75880630646264e-07 -0.09068063247437069 +0.9935 0.6904411880277905 0.6904401669067941 7.782304494025061e-07 -0.09068333164083506 +0.9936 0.6904460819707892 0.6904450435835952 7.803992316951502e-07 -0.09068603006372732 +0.9937 0.6904509745541865 0.6904499188591828 7.82386540609803e-07 -0.09068872774323024 +0.9938 0.6904558657764341 0.6904547927358249 7.841919791862217e-07 -0.09069142467952648 +0.9939000000000001 0.6904607556359812 0.690459665215793 7.858151906542377e-07 -0.09069412087279877 +0.994 0.6904656441312719 0.6904645363013621 7.872558583643663e-07 -0.09069681632322962 +0.9941 0.6904705312607485 0.6904694059948094 7.885137059404634e-07 -0.09069951103100171 +0.9942000000000001 0.6904754170228506 0.6904742742984155 7.895884972797251e-07 -0.09070220499629758 +0.9943000000000001 0.6904803014160151 0.6904791412144622 7.904800366359543e-07 -0.09070489821929975 +0.9944000000000001 0.6904851844386778 0.6904840067452332 7.911881685224165e-07 -0.09070759070019077 +0.9945 0.6904900660892728 0.6904888708930135 7.91712778058784e-07 -0.09071028243915306 +0.9946 0.6904949463662333 0.6904937336600883 7.920537905548031e-07 -0.09071297343636907 +0.9947 0.6904998252679924 0.6904985950487434 7.922111719127489e-07 -0.09071566369202122 +0.9948 0.6905047027929829 0.6905034550612648 7.921849283082372e-07 -0.09071835320629182 +0.9949000000000001 0.690509578939638 0.6905083136999373 7.919751064955349e-07 -0.09072104197936326 +0.995 0.6905144537063919 0.6905131709670451 7.915817935161273e-07 -0.09072373001141781 +0.9951 0.6905193270916796 0.6905180268648714 7.910051168236176e-07 -0.0907264173026378 +0.9952000000000001 0.6905241990939384 0.6905228813956967 7.902452441171937e-07 -0.09072910385320541 +0.9953000000000001 0.6905290697116073 0.6905277345617999 7.893023834387725e-07 -0.0907317896633029 +0.9954000000000001 0.690533938943128 0.690532586365457 7.881767831313669e-07 -0.09073447473311243 +0.9955 0.6905388067869448 0.690537436808941 7.86868731672552e-07 -0.09073715906281614 +0.9956 0.6905436732415056 0.690542285894521 7.853785575356875e-07 -0.09073984265259612 +0.9957 0.690548538305262 0.6905471336244631 7.837066293286954e-07 -0.09074252550263447 +0.9958 0.6905534019766699 0.690551980001028 7.818533555581375e-07 -0.09074520761311325 +0.9959000000000001 0.6905582642541898 0.6905568250264725 7.798191845598268e-07 -0.09074788898421444 +0.996 0.6905631251362869 0.6905616687030477 7.776046043878049e-07 -0.09075056961612009 +0.9961 0.6905679846214328 0.6905665110329993 7.752101427171976e-07 -0.09075324950901213 +0.9962000000000001 0.6905728427081036 0.6905713520185667 7.726363666776814e-07 -0.09075592866307246 +0.9963000000000001 0.6905776993947825 0.6905761916619831 7.698838828673615e-07 -0.09075860707848295 +0.9964000000000001 0.6905825546799595 0.6905810299654754 7.669533369641934e-07 -0.09076128475542555 +0.9965 0.6905874085621315 0.6905858669312623 7.638454137398609e-07 -0.09076396169408206 +0.9966 0.6905922610398025 0.6905907025615554 7.605608369071204e-07 -0.09076663789463418 +0.9967 0.6905971121114847 0.6905955368585579 7.571003688838784e-07 -0.09076931335726375 +0.9968 0.6906019617756988 0.6906003698244649 7.53464810654414e-07 -0.09077198808215246 +0.9969000000000001 0.6906068100309739 0.6906052014614625 7.496550016167225e-07 -0.09077466206948202 +0.997 0.6906116568758482 0.6906100317717274 7.456718193743495e-07 -0.09077733531943405 +0.9971 0.6906165023088702 0.6906148607574268 7.415161793755676e-07 -0.09078000783219024 +0.9972000000000001 0.6906213463285971 0.6906196884207181 7.371890349827659e-07 -0.0907826796079322 +0.9973000000000001 0.6906261889335974 0.6906245147637475 7.326913770699939e-07 -0.09078535064684146 +0.9974000000000001 0.6906310301224496 0.6906293397886509 7.280242339258169e-07 -0.09078802094909959 +0.9975 0.6906358698937439 0.690634163497553 7.23188670823105e-07 -0.09079069051488807 +0.9976 0.6906407082460817 0.6906389858925667 7.18185789921888e-07 -0.09079335934438841 +0.9977 0.6906455451780757 0.6906438069757928 7.130167299779222e-07 -0.09079602743778198 +0.9978 0.6906503806883519 0.6906486267493195 7.076826661622793e-07 -0.09079869479525021 +0.9979000000000001 0.6906552147755481 0.6906534452152229 7.021848096866457e-07 -0.09080136141697448 +0.998 0.6906600474383155 0.6906582623755654 6.965244075396448e-07 -0.09080402730313615 +0.9981 0.6906648786753184 0.6906630782323961 6.907027422925482e-07 -0.09080669245391651 +0.9982000000000001 0.6906697084852351 0.6906678927877503 6.847211317523305e-07 -0.09080935686949686 +0.9983000000000001 0.690674536866758 0.6906727060436489 6.785809286979916e-07 -0.09081202055005841 +0.9984000000000001 0.6906793638185934 0.6906775180020982 6.722835204087119e-07 -0.09081468349578241 +0.9985 0.6906841893394633 0.6906823286650893 6.658303287193634e-07 -0.09081734570685 +0.9986 0.6906890134281046 0.6906871380345984 6.592228092849872e-07 -0.09082000718344241 +0.9987 0.6906938360832693 0.6906919461125856 6.524624514697708e-07 -0.09082266792574067 +0.9988 0.6906986573037256 0.6906967529009951 6.455507780001035e-07 -0.09082532793392588 +0.9989000000000001 0.6907034770882581 0.6907015584017551 6.384893446037543e-07 -0.09082798720817914 +0.999 0.6907082954356676 0.6907063626167764 6.31279739635171e-07 -0.09083064574868142 +0.9991 0.6907131123447725 0.6907111655479532 6.239235838811918e-07 -0.09083330355561378 +0.9992000000000001 0.6907179278144078 0.6907159671971619 6.164225298255221e-07 -0.09083596062915711 +0.9993000000000001 0.6907227418434259 0.6907207675662617 6.08778261759757e-07 -0.09083861696949234 +0.9994000000000001 0.6907275544306977 0.6907255666570935 6.009924950201029e-07 -0.09084127257680041 +0.9995 0.6907323655751123 0.6907303644714795 5.930669757098217e-07 -0.09084392745126216 +0.9996 0.6907371752755771 0.6907351610112233 5.850034804355531e-07 -0.09084658159305838 +0.9997 0.6907419835310185 0.6907399562781101 5.768038158077138e-07 -0.09084923500236991 +0.9998 0.6907467903403819 0.6907447502739048 5.684698180102865e-07 -0.09085188767937752 +0.9999000000000001 0.6907515957026324 0.6907495430003533 5.600033524122416e-07 -0.09085453962426188 +1.0 0.6907563996167552 0.6907543344591814 5.514063132899816e-07 -0.09085719083720374 +1.0001 0.6907612020817545 0.6907591246520949 5.426806231334513e-07 -0.09085984131838379 +1.0002 0.6907660030966559 0.6907639135807782 5.338282323824606e-07 -0.09086249106798255 +1.0003 0.6907708026605055 0.6907687012468959 5.248511190381056e-07 -0.09086514008618075 +1.0004000000000002 0.6907756007723701 0.6907734876520912 5.15751288079902e-07 -0.09086778837315891 +1.0005 0.690780397431338 0.6907782727979854 5.065307712298628e-07 -0.09087043592909755 +1.0006 0.6907851926365187 0.690783056686179 4.971916262030973e-07 -0.09087308275417726 +1.0007000000000001 0.6907899863870439 0.6907878393182496 4.877359365412781e-07 -0.09087572884857842 +1.0008000000000001 0.6907947786820671 0.6907926206957533 4.781658109187514e-07 -0.09087837421248149 +1.0009000000000001 0.6907995695207637 0.6907974008202237 4.684833828511037e-07 -0.0908810188460669 +1.001 0.6908043589023324 0.690802179693171 4.5869081005678325e-07 -0.090883662749515 +1.0011 0.6908091468259943 0.6908069573160833 4.487902741379113e-07 -0.09088630592300613 +1.0012 0.6908139332909936 0.6908117336904254 4.387839799835369e-07 -0.09088894836672068 +1.0013 0.6908187182965981 0.690816508817638 4.2867415535330355e-07 -0.09089159008083886 +1.0014 0.6908235018420987 0.6908212826991387 4.1846305028764297e-07 -0.09089423106554095 +1.0015 0.6908282839268101 0.6908260553363208 4.0815293674001385e-07 -0.09089687132100714 +1.0016 0.6908330645500713 0.690830826730554 3.9774610789689024e-07 -0.09089951084741765 +1.0017 0.6908378437112451 0.6908355968831829 3.872448778655113e-07 -0.09090214964495255 +1.0018 0.6908426214097196 0.6908403657955282 3.766515809661142e-07 -0.09090478771379211 +1.0019 0.6908473976449062 0.6908451334688852 3.6596857140580585e-07 -0.09090742505411627 +1.002 0.690852172416242 0.6908498999045249 3.5519822257773503e-07 -0.09091006166610517 +1.0021 0.6908569457231888 0.690854665103693 3.443429266586362e-07 -0.0909126975499388 +1.0022 0.690861717565234 0.6908594290676089 3.334050940467792e-07 -0.09091533270579712 +1.0023 0.69086648794189 0.6908641917974678 3.2238715279298e-07 -0.09091796713386013 +1.0024000000000002 0.6908712568526951 0.6908689532944382 3.1129154811487814e-07 -0.0909206008343078 +1.0025 0.6908760242972128 0.6908737135596632 3.001207417516194e-07 -0.09092323380731994 +1.0026 0.6908807902750336 0.6908784725942596 2.8887721156140023e-07 -0.09092586605307647 +1.0027000000000001 0.6908855547857728 0.6908832303993178 2.775634508761504e-07 -0.0909284975717572 +1.0028000000000001 0.6908903178290731 0.6908879869759021 2.6618196800887173e-07 -0.09093112836354195 +1.0029000000000001 0.6908950794046025 0.6908927423250499 2.54735285587504e-07 -0.09093375842861036 +1.003 0.6908998395120565 0.6908974964477725 2.4322594017328614e-07 -0.09093638776714233 +1.0031 0.6909045981511566 0.690902249345054 2.31656481532172e-07 -0.09093901637931746 +1.0032 0.6909093553216518 0.6909070010178513 2.200294721074747e-07 -0.0909416442653155 +1.0033 0.6909141110233173 0.6909117514670944 2.0834748658271618e-07 -0.090944271425316 +1.0034 0.690918865255956 0.6909165006936866 1.9661311114610447e-07 -0.09094689785949862 +1.0035 0.6909236180193977 0.6909212486985028 1.8482894296317776e-07 -0.09094952356804296 +1.0036 0.6909283693134995 0.6909259954823912 1.7299758968414292e-07 -0.09095214855112849 +1.0037 0.6909331191381458 0.6909307410461722 1.611216687708028e-07 -0.09095477280893476 +1.0038 0.6909378674932487 0.6909354853906391 1.492038069449142e-07 -0.09095739634164118 +1.0039 0.6909426143787474 0.6909402285165562 1.3724663962960681e-07 -0.09096001914942722 +1.004 0.6909473597946098 0.6909449704246613 1.2525281035957736e-07 -0.09096264123247236 +1.0041 0.6909521037408306 0.6909497111156637 1.1322497017740574e-07 -0.09096526259095593 +1.0042 0.6909568462174327 0.6909544505902447 1.0116577705762686e-07 -0.09096788322505726 +1.0043 0.690961587224467 0.6909591888490578 8.907789531692467e-08 -0.0909705031349557 +1.0044000000000002 0.6909663267620118 0.6909639258927278 7.696399504861229e-08 -0.09097312232083049 +1.0045 0.6909710648301739 0.6909686617218522 6.482675151721351e-08 -0.09097574078286089 +1.0046 0.6909758014290883 0.6909733963369998 5.266884454437071e-08 -0.09097835852122611 +1.0047000000000001 0.6909805365589178 0.690978129738711 4.049295795720276e-08 -0.09098097553610539 +1.0048000000000001 0.6909852702198535 0.6909828619274982 2.830177895860042e-08 -0.09098359182767785 +1.0049000000000001 0.6909900024121143 0.6909875929038456 1.6097997570380107e-08 -0.0909862073961226 +1.005 0.6909947331359476 0.6909923226682085 3.884306013987593e-09 -0.09098882224161871 +1.0051 0.6909994623916289 0.6909970512210146 -8.336601871501703e-09 -0.09099143636434526 +1.0052 0.6910041901794624 0.6910017785626625 -2.0562031226561278e-08 -0.09099404976448129 +1.0053 0.6910089164997796 0.6910065046935231 -3.278928677272891e-08 -0.09099666244220578 +1.0054 0.6910136413529409 0.6910112296139385 -4.5015673391245355e-08 -0.0909992743976977 +1.0055 0.6910183647393348 0.6910159533242224 -5.723849673096651e-08 -0.09100188563113594 +1.0056 0.6910230866593776 0.6910206758246602 -6.945506379751887e-08 -0.09100449614269943 +1.0057 0.6910278071135145 0.6910253971155091 -8.166268354332235e-08 -0.09100710593256696 +1.0058 0.6910325261022185 0.6910301171969979 -9.385866746487725e-08 -0.09100971500091747 +1.0059 0.6910372436259904 0.6910348360693275 -1.0604033019376291e-07 -0.09101232334792965 +1.006 0.6910419596853592 0.6910395537326698 -1.1820499008427521e-07 -0.09101493097378231 +1.0061 0.6910466742808822 0.6910442701871693 -1.3034996981797775e-07 -0.09101753787865419 +1.0062 0.691051387413145 0.6910489854329418 -1.4247259695621128e-07 -0.09102014406272402 +1.0063 0.6910560990827604 0.6910536994700753 -1.5457020458888027e-07 -0.09102274952617044 +1.0064000000000002 0.6910608092903696 0.6910584122986297 -1.6664013186701299e-07 -0.09102535426917206 +1.0065 0.6910655180366412 0.691063123918637 -1.7867972460644532e-07 -0.09102795829190753 +1.0066 0.6910702253222716 0.6910678343301013 -1.9068633588456563e-07 -0.09103056159455541 +1.0067000000000002 0.6910749311479851 0.6910725435329991 -2.0265732660409985e-07 -0.09103316417729426 +1.0068000000000001 0.6910796355145332 0.6910772515272786 -2.1459006608465225e-07 -0.09103576604030252 +1.0069000000000001 0.6910843384226952 0.6910819583128609 -2.264819326386336e-07 -0.09103836718375868 +1.007 0.6910890398732774 0.6910866638896396 -2.3833031411249483e-07 -0.09104096760784122 +1.0071 0.691093739867114 0.6910913682574809 -2.50132608552861e-07 -0.09104356731272856 +1.0072 0.6910984384050654 0.6910960714162233 -2.6188622467143707e-07 -0.09104616629859902 +1.0073 0.6911031354880195 0.6911007733656784 -2.7358858248338613e-07 -0.09104876456563096 +1.0074 0.6911078311168916 0.6911054741056311 -2.852371138485632e-07 -0.09105136211400272 +1.0075 0.6911125252926229 0.6911101736358389 -2.9682926303009616e-07 -0.09105395894389262 +1.0076 0.6911172180161815 0.6911148719560327 -3.0836248729460003e-07 -0.0910565550554788 +1.0077 0.6911219092885622 0.6911195690659167 -3.198342574187163e-07 -0.09105915044893956 +1.0078 0.691126599110786 0.6911242649651687 -3.312420582615716e-07 -0.09106174512445303 +1.0079 0.6911312874839003 0.69112895965344 -3.4258338932335874e-07 -0.0910643390821974 +1.008 0.691135974408978 0.6911336531303559 -3.5385576530738705e-07 -0.09106693232235076 +1.0081 0.6911406598871185 0.691138345395516 -3.6505671661968275e-07 -0.09106952484509126 +1.0082 0.6911453439194464 0.6911430364484934 -3.7618378997267277e-07 -0.0910721166505969 +1.0083 0.691150026507112 0.6911477262888355 -3.8723454887090725e-07 -0.09107470773904573 +1.0084000000000002 0.6911547076512912 0.6911524149160649 -3.982065741592322e-07 -0.09107729811061571 +1.0085 0.6911593873531847 0.6911571023296785 -4.090974645709622e-07 -0.09107988776548487 +1.0086 0.6911640656140179 0.6911617885291478 -4.199048372274805e-07 -0.09108247670383099 +1.0087000000000002 0.6911687424350417 0.6911664735139199 -4.3062632822110647e-07 -0.09108506492583208 +1.0088000000000001 0.691173417817531 0.691171157283417 -4.4125959301755113e-07 -0.09108765243166599 +1.0089000000000001 0.6911780917627854 0.6911758398370368 -4.518023070873567e-07 -0.09109023922151051 +1.009 0.6911827642721279 0.6911805211741529 -4.62252166329169e-07 -0.09109282529554344 +1.0091 0.6911874353469063 0.6911852012941145 -4.7260688759709346e-07 -0.09109541065394257 +1.0092 0.6911921049884917 0.6911898801962473 -4.828642092766233e-07 -0.09109799529688559 +1.0093 0.6911967731982787 0.6911945578798531 -4.930218916454621e-07 -0.0911005792245503 +1.0094 0.6912014399776849 0.6911992343442103 -5.030777174633294e-07 -0.0911031624371142 +1.0095 0.6912061053281515 0.6912039095885745 -5.130294924368672e-07 -0.0911057449347551 +1.0096 0.6912107692511416 0.6912085836121784 -5.228750456429121e-07 -0.09110832671765047 +1.0097 0.691215431748141 0.6912132564142318 -5.326122300766678e-07 -0.09111090778597797 +1.0098 0.6912200928206584 0.6912179279939223 -5.422389231096725e-07 -0.0911134881399151 +1.0099 0.6912247524702237 0.6912225983504151 -5.517530269061321e-07 -0.09111606777963932 +1.01 0.691229410698389 0.6912272674828541 -5.611524689502767e-07 -0.09111864670532818 +1.0101 0.6912340675067272 0.6912319353903611 -5.704352023794268e-07 -0.09112122491715909 +1.0102 0.6912387228968332 0.6912366020720366 -5.79599206559922e-07 -0.09112380241530942 +1.0103 0.6912433768703221 0.6912412675269608 -5.886424874618212e-07 -0.09112637919995661 +1.0104000000000002 0.6912480294288297 0.6912459317541924 -5.975630781307473e-07 -0.091128955271278 +1.0105 0.6912526805740122 0.6912505947527697 -6.063590390348317e-07 -0.09113153062945084 +1.0106 0.6912573303075462 0.6912552565217112 -6.150284586059485e-07 -0.09113410527465243 +1.0107000000000002 0.6912619786311271 0.6912599170600149 -6.235694535311476e-07 -0.09113667920706003 +1.0108000000000001 0.6912666255464712 0.6912645763666603 -6.31980169335522e-07 -0.0911392524268509 +1.0109000000000001 0.6912712710553122 0.6912692344406067 -6.40258780576497e-07 -0.09114182493420218 +1.011 0.6912759151594035 0.6912738912807949 -6.484034913295522e-07 -0.091144396729291 +1.0111 0.691280557860517 0.6912785468861469 -6.56412535660067e-07 -0.09114696781229452 +1.0112 0.6912851991604423 0.6912832012555661 -6.642841779147535e-07 -0.09114953818338974 +1.0113 0.6912898390609874 0.6912878543879386 -6.720167131379906e-07 -0.0911521078427538 +1.0114 0.6912944775639775 0.6912925062821325 -6.796084673493796e-07 -0.0911546767905637 +1.0115 0.6912991146712553 0.6912971569369982 -6.870577980017112e-07 -0.0911572450269964 +1.0116 0.6913037503846797 0.6913018063513697 -6.943630944111767e-07 -0.09115981255222888 +1.0117 0.691308384706127 0.6913064545240637 -7.015227778961464e-07 -0.09116237936643805 +1.0118 0.6913130176374889 0.6913111014538814 -7.085353022906471e-07 -0.0911649454698008 +1.0119 0.6913176491806732 0.6913157471396072 -7.153991542357963e-07 -0.09116751086249397 +1.012 0.6913222793376035 0.6913203915800104 -7.221128534573573e-07 -0.09117007554469445 +1.0121 0.6913269081102181 0.6913250347738447 -7.286749531126846e-07 -0.091172639516579 +1.0122 0.6913315355004703 0.6913296767198491 -7.350840401654235e-07 -0.09117520277832437 +1.0123 0.6913361615103277 0.6913343174167479 -7.413387355797996e-07 -0.09117776533010732 +1.0124000000000002 0.6913407861417722 0.6913389568632509 -7.474376947508299e-07 -0.09118032717210449 +1.0125 0.6913454093967987 0.6913435950580546 -7.53379607643101e-07 -0.09118288830449256 +1.0126 0.6913500312774163 0.6913482319998421 -7.591631991793468e-07 -0.09118544872744819 +1.0127000000000002 0.6913546517856464 0.6913528676872827 -7.647872294902491e-07 -0.0911880084411479 +1.0128000000000001 0.6913592709235239 0.6913575021190332 -7.702504941642374e-07 -0.09119056744576835 +1.0129000000000001 0.6913638886930948 0.6913621352937387 -7.755518245250448e-07 -0.09119312574148608 +1.013 0.6913685050964179 0.6913667672100314 -7.80690087895386e-07 -0.09119568332847756 +1.0131000000000001 0.6913731201355624 0.6913713978665325 -7.85664187805124e-07 -0.09119824020691925 +1.0132 0.6913777338126095 0.6913760272618514 -7.904730642133151e-07 -0.09120079637698758 +1.0133 0.6913823461296509 0.6913806553945872 -7.951156937441306e-07 -0.09120335183885897 +1.0134 0.6913869570887881 0.6913852822633287 -7.995910900199243e-07 -0.09120590659270982 +1.0135 0.6913915666921331 0.6913899078666539 -8.038983036473546e-07 -0.0912084606387164 +1.0136 0.6913961749418072 0.6913945322031316 -8.080364226614734e-07 -0.0912110139770551 +1.0137 0.6914007818399405 0.6913991552713215 -8.120045725257263e-07 -0.0912135666079021 +1.0138 0.6914053873886724 0.6914037770697739 -8.158019164927754e-07 -0.09121611853143374 +1.0139 0.6914099915901505 0.6914083975970311 -8.194276556044988e-07 -0.0912186697478262 +1.014 0.6914145944465295 0.6914130168516268 -8.228810288862798e-07 -0.09122122025725557 +1.0141 0.6914191959599733 0.6914176348320881 -8.261613136523183e-07 -0.09122377005989815 +1.0142 0.691423796132651 0.6914222515369335 -8.292678256027752e-07 -0.09122631915592996 +1.0143 0.6914283949667401 0.6914268669646753 -8.321999188376505e-07 -0.0912288675455271 +1.0144000000000002 0.6914329924644232 0.6914314811138191 -8.349569861482165e-07 -0.09123141522886558 +1.0145 0.6914375886278896 0.691436093982865 -8.375384589753843e-07 -0.0912339622061215 +1.0146 0.6914421834593337 0.6914407055703066 -8.399438077844046e-07 -0.09123650847747077 +1.0147 0.6914467769609551 0.6914453158746329 -8.421725419538451e-07 -0.09123905404308938 +1.0148000000000001 0.6914513691349577 0.6914499248943277 -8.442242098727348e-07 -0.0912415989031532 +1.0149000000000001 0.6914559599835506 0.6914545326278709 -8.460983992736315e-07 -0.09124414305783819 +1.015 0.6914605495089458 0.6914591390737376 -8.477947369550654e-07 -0.09124668650732014 +1.0151000000000001 0.6914651377133592 0.6914637442304 -8.493128891839952e-07 -0.09124922925177492 +1.0152 0.6914697245990099 0.6914683480963268 -8.506525615015192e-07 -0.09125177129137832 +1.0153 0.6914743101681191 0.6914729506699838 -8.518134990836979e-07 -0.09125431262630604 +1.0154 0.6914788944229106 0.6914775519498348 -8.527954865056309e-07 -0.09125685325673384 +1.0155 0.69148347736561 0.6914821519343417 -8.535983477553355e-07 -0.09125939318283746 +1.0156 0.6914880589984438 0.6914867506219644 -8.542219466362022e-07 -0.09126193240479251 +1.0157 0.6914926393236401 0.691491348011162 -8.546661864061722e-07 -0.09126447092277457 +1.0158 0.6914972183434271 0.6914959441003928 -8.549310099442708e-07 -0.09126700873695932 +1.0159 0.6915017960600331 0.6915005388881151 -8.550163997089744e-07 -0.09126954584752225 +1.016 0.6915063724756866 0.6915051323727874 -8.549223778769877e-07 -0.09127208225463901 +1.0161 0.6915109475926147 0.6915097245528683 -8.546490061489553e-07 -0.09127461795848497 +1.0162 0.6915155214130436 0.6915143154268175 -8.541963857772172e-07 -0.09127715295923565 +1.0163 0.6915200939391986 0.6915189049930963 -8.535646576768308e-07 -0.09127968725706649 +1.0164000000000002 0.691524665173302 0.6915234932501678 -8.527540021341373e-07 -0.09128222085215289 +1.0165 0.6915292351175746 0.691528080196497 -8.517646388483957e-07 -0.09128475374467017 +1.0166 0.6915338037742337 0.6915326658305518 -8.505968271260711e-07 -0.0912872859347937 +1.0167 0.6915383711454941 0.6915372501508033 -8.492508654506237e-07 -0.0912898174226988 +1.0168000000000001 0.6915429372335664 0.6915418331557256 -8.477270916906754e-07 -0.09129234820856072 +1.0169000000000001 0.6915475020406575 0.6915464148437973 -8.460258826836764e-07 -0.0912948782925547 +1.017 0.6915520655689699 0.6915509952135007 -8.441476545828497e-07 -0.09129740767485596 +1.0171000000000001 0.6915566278207008 0.6915555742633231 -8.420928623992241e-07 -0.09129993635563965 +1.0172 0.6915611887980428 0.6915601519917571 -8.398620000432677e-07 -0.09130246433508099 +1.0173 0.6915657485031824 0.6915647283973001 -8.374556002138656e-07 -0.09130499161335497 +1.0174 0.6915703069383001 0.6915693034784558 -8.348742342734194e-07 -0.0913075181906367 +1.0175 0.6915748641055701 0.691573877233735 -8.321185120119257e-07 -0.09131004406710133 +1.0176 0.6915794200071596 0.6915784496616538 -8.291890817024861e-07 -0.09131256924292372 +1.0177 0.6915839746452284 0.6915830207607363 -8.260866296572189e-07 -0.09131509371827892 +1.0178 0.6915885280219287 0.6915875905295142 -8.228118803799145e-07 -0.09131761749334188 +1.0179 0.6915930801394048 0.6915921589665267 -8.193655961774571e-07 -0.09132014056828751 +1.018 0.6915976309997924 0.6915967260703216 -8.157485771320694e-07 -0.09132266294329071 +1.0181 0.6916021806052184 0.6916012918394552 -8.119616607821234e-07 -0.09132518461852628 +1.0182 0.6916067289578003 0.6916058562724932 -8.080057220388737e-07 -0.09132770559416906 +1.0183 0.6916112760596461 0.6916104193680107 -8.038816729227793e-07 -0.09133022587039391 +1.0184000000000002 0.6916158219128536 0.6916149811245924 -7.995904623692152e-07 -0.09133274544737546 +1.0185 0.6916203665195105 0.6916195415408335 -7.951330761035713e-07 -0.0913352643252885 +1.0186 0.6916249098816933 0.6916241006153399 -7.905105362665532e-07 -0.09133778250430771 +1.0187 0.6916294520014674 0.6916286583467284 -7.857239011505035e-07 -0.09134029998460774 +1.0188000000000001 0.691633992880887 0.6916332147336273 -7.807742651577687e-07 -0.09134281676636319 +1.0189000000000001 0.6916385325219936 0.6916377697746768 -7.756627585092657e-07 -0.09134533284974866 +1.019 0.6916430709268175 0.6916423234685294 -7.703905468142702e-07 -0.09134784823493874 +1.0191000000000001 0.6916476080973752 0.6916468758138494 -7.649588309038835e-07 -0.09135036292210796 +1.0192 0.6916521440356707 0.691651426809315 -7.593688467061321e-07 -0.09135287691143076 +1.0193 0.6916566787436947 0.6916559764536168 -7.536218646908566e-07 -0.09135539020308166 +1.0194 0.6916612122234236 0.6916605247454592 -7.477191898141999e-07 -0.091357902797235 +1.0195 0.6916657444768204 0.6916650716835614 -7.416621610190077e-07 -0.09136041469406526 +1.0196 0.6916702755058329 0.6916696172666559 -7.35452151151561e-07 -0.09136292589374678 +1.0197 0.6916748053123944 0.6916741614934903 -7.290905665174874e-07 -0.09136543639645386 +1.0198 0.6916793338984234 0.6916787043628274 -7.225788465764493e-07 -0.09136794620236088 +1.0199 0.6916838612658218 0.6916832458734452 -7.159184636923444e-07 -0.09137045531164201 +1.02 0.6916883874164765 0.6916877860241373 -7.091109226753378e-07 -0.0913729637244715 +1.0201 0.6916929123522582 0.6916923248137138 -7.021577604349183e-07 -0.0913754714410236 +1.0202 0.6916974360750202 0.6916968622410008 -6.950605459105086e-07 -0.09137797846147244 +1.0203 0.6917019585865999 0.6917013983048416 -6.878208793775764e-07 -0.0913804847859922 +1.0204000000000002 0.6917064798888168 0.6917059330040958 -6.804403922533453e-07 -0.09138299041475692 +1.0205 0.6917109999834737 0.6917104663376412 -6.729207467359721e-07 -0.09138549534794073 +1.0206 0.6917155188723545 0.6917149983043727 -6.652636352633134e-07 -0.09138799958571764 +1.0207 0.6917200365572256 0.6917195289032037 -6.574707805545588e-07 -0.09139050312826169 +1.0208000000000002 0.6917245530398347 0.6917240581330653 -6.495439346387855e-07 -0.09139300597574679 +1.0209000000000001 0.6917290683219106 0.6917285859929079 -6.414848789104699e-07 -0.0913955081283469 +1.021 0.6917335824051634 0.6917331124817006 -6.332954235188648e-07 -0.09139800958623595 +1.0211000000000001 0.6917380952912835 0.6917376375984317 -6.249774071043213e-07 -0.09140051034958785 +1.0212 0.6917426069819415 0.6917421613421086 -6.165326962292994e-07 -0.09140301041857635 +1.0213 0.6917471174787884 0.6917466837117598 -6.079631850869349e-07 -0.09140550979337533 +1.0214 0.6917516267834547 0.6917512047064328 -5.992707949598053e-07 -0.09140800847415861 +1.0215 0.6917561348975503 0.6917557243251956 -5.904574739284962e-07 -0.09141050646109986 +1.0216 0.6917606418226644 0.691760242567137 -5.81525196399757e-07 -0.09141300375437278 +1.0217 0.691765147560365 0.6917647594313672 -5.724759624681219e-07 -0.09141550035415111 +1.0218 0.6917696521121991 0.6917692749170166 -5.633117977632551e-07 -0.09141799626060845 +1.0219 0.6917741554796917 0.6917737890232383 -5.540347528532052e-07 -0.0914204914739185 +1.022 0.6917786576643459 0.6917783017492061 -5.446469027586831e-07 -0.09142298599425476 +1.0221 0.6917831586676431 0.6917828130941165 -5.351503465228502e-07 -0.09142547982179085 +1.0222 0.6917876584910416 0.6917873230571876 -5.255472068504963e-07 -0.09142797295670022 +1.0223 0.6917921571359779 0.6917918316376603 -5.158396293586387e-07 -0.09143046539915639 +1.0224000000000002 0.6917966546038646 0.6917963388347985 -5.060297824308058e-07 -0.09143295714933275 +1.0225 0.6918011508960926 0.6918008446478885 -4.96119856474575e-07 -0.09143544820740285 +1.0226 0.6918056460140285 0.6918053490762401 -4.861120635954452e-07 -0.09143793857354002 +1.0227 0.6918101399590157 0.6918098521191864 -4.7600863699315266e-07 -0.0914404282479176 +1.0228000000000002 0.6918146327323735 0.6918143537760841 -4.6581183055227626e-07 -0.09144291723070894 +1.0229000000000001 0.6918191243353974 0.6918188540463139 -4.555239182454929e-07 -0.09144540552208733 +1.023 0.6918236147693588 0.6918233529292802 -4.451471937588769e-07 -0.09144789312222601 +1.0231000000000001 0.691828104035505 0.691827850424412 -4.3468396979801094e-07 -0.09145038003129827 +1.0232 0.6918325921350581 0.6918323465311622 -4.2413657776879665e-07 -0.09145286624947721 +1.0233 0.6918370790692158 0.691836841249009 -4.1350736711132097e-07 -0.09145535177693603 +1.0234 0.6918415648391507 0.6918413345774549 -4.02798704911278e-07 -0.09145783661384788 +1.0235 0.6918460494460108 0.6918458265160277 -3.920129752060797e-07 -0.09146032076038589 +1.0236 0.6918505328909178 0.6918503170642799 -3.811525785893388e-07 -0.09146280421672304 +1.0237 0.6918550151749687 0.6918548062217897 -3.7021993162106304e-07 -0.09146528698303241 +1.0238 0.6918594962992348 0.6918592939881608 -3.5921746628642115e-07 -0.09146776905948699 +1.0239 0.6918639762647613 0.6918637803630225 -3.481476295377761e-07 -0.09147025044625974 +1.024 0.6918684550725676 0.6918682653460297 -3.3701288259385676e-07 -0.09147273114352361 +1.0241000000000002 0.6918729327236472 0.6918727489368635 -3.2581570050954634e-07 -0.09147521115145153 +1.0242 0.6918774092189672 0.691877231135231 -3.1455857160689327e-07 -0.09147769047021637 +1.0243 0.6918818845594683 0.6918817119408653 -3.0324399697551074e-07 -0.09148016909999089 +1.0244000000000002 0.6918863587460642 0.6918861913535261 -2.91874489737054e-07 -0.09148264704094794 +1.0245 0.6918908317796434 0.6918906693729996 -2.8045257469133666e-07 -0.09148512429326033 +1.0246000000000002 0.6918953036610662 0.6918951459990983 -2.689807876675443e-07 -0.09148760085710075 +1.0247 0.691899774391167 0.6918996212316617 -2.5746167489626437e-07 -0.09149007673264195 +1.0248 0.6919042439707528 0.6919040950705557 -2.458977926139694e-07 -0.09149255192005656 +1.0249000000000001 0.6919087124006034 0.6919085675156734 -2.3429170632749408e-07 -0.09149502641951722 +1.025 0.6919131796814719 0.6919130385669351 -2.22645990321374e-07 -0.09149750023119656 +1.0251000000000001 0.6919176458140843 0.6919175082242877 -2.1096322708885618e-07 -0.09149997335526718 +1.0252000000000001 0.6919221107991389 0.6919219764877056 -1.9924600675944037e-07 -0.09150244579190162 +1.0252999999999999 0.6919265746373066 0.6919264433571901 -1.8749692649519534e-07 -0.09150491754127238 +1.0254 0.6919310373292309 0.6919309088327703 -1.7571858994952505e-07 -0.09150738860355195 +1.0255 0.6919354988755282 0.6919353729145021 -1.6391360666348498e-07 -0.09150985897891278 +1.0256 0.6919399592767868 0.6919398356024691 -1.5208459152628306e-07 -0.09151232866752729 +1.0257 0.6919444185335677 0.6919442968967824 -1.4023416414210566e-07 -0.09151479766956784 +1.0258 0.6919488766464041 0.6919487567975804 -1.28364948275006e-07 -0.09151726598520682 +1.0259 0.6919533336158017 0.6919532153050293 -1.1647957130246633e-07 -0.09151973361461652 +1.026 0.6919577894422381 0.6919576724193226 -1.0458066357701967e-07 -0.09152220055796921 +1.0261000000000002 0.6919622441261635 0.6919621281406818 -9.267085787981189e-08 -0.0915246668154372 +1.0262 0.6919666976680001 0.6919665824693557 -8.075278882732628e-08 -0.09152713238719264 +1.0263 0.6919711500681424 0.6919710354056208 -6.882909228851652e-08 -0.09152959727340777 +1.0264000000000002 0.6919756013269573 0.6919754869497812 -5.6902404802806894e-08 -0.09153206147425474 +1.0265 0.6919800514447836 0.6919799371021684 -4.497536300156202e-08 -0.09153452498990562 +1.0266000000000002 0.6919845004219322 0.6919843858631428 -3.30506030194193e-08 -0.09153698782053256 +1.0267 0.6919889482586867 0.6919888332330909 -2.113075991158446e-08 -0.09153944996630764 +1.0268 0.6919933949553029 0.6919932792124273 -9.21846707432547e-09 -0.09154191142740281 +1.0269000000000001 0.6919978405120084 0.6919977238015943 2.683644338002944e-09 -0.0915443722039901 +1.027 0.6920022849290031 0.6920021670010621 1.4572945996639552e-08 -0.09154683229624146 +1.0271000000000001 0.6920067282064599 0.6920066088113279 2.644681296876117e-08 -0.09154929170432888 +1.0272000000000001 0.6920111703445233 0.6920110492329167 3.830262430490339e-08 -0.09155175042842417 +1.0272999999999999 0.692015611343311 0.6920154882663805 5.013776363006761e-08 -0.09155420846869926 +1.0274 0.6920200512029122 0.6920199259122993 6.194961968929158e-08 -0.09155666582532594 +1.0275 0.6920244899233894 0.6920243621712799 7.37355869591394e-08 -0.09155912249847603 +1.0276 0.6920289275047775 0.6920287970439567 8.549306619587416e-08 -0.09156157848832128 +1.0277 0.6920333639470837 0.6920332305309913 9.721946502352918e-08 -0.09156403379503346 +1.0278 0.6920377992502887 0.6920376626330722 1.0891219849248901e-07 -0.09156648841878427 +1.0279 0.6920422334143455 0.6920420933509148 1.2056868967449952e-07 -0.09156894235974536 +1.028 0.6920466664391793 0.6920465226852617 1.3218637021084056e-07 -0.0915713956180883 +1.0281000000000002 0.6920510983246901 0.692050950636882 1.4376268089172362e-07 -0.09157384819398476 +1.0282 0.69205552907075 0.6920553772065723 1.5529507215936156e-07 -0.09157630008760637 +1.0283 0.6920599586772038 0.6920598023951551 1.6678100477410251e-07 -0.09157875129912457 +1.0284 0.6920643871438703 0.6920642262034793 1.782179503070913e-07 -0.09158120182871088 +1.0285 0.692068814470542 0.6920686486324211 1.8960339169885043e-07 -0.09158365167653681 +1.0286000000000002 0.6920732406569842 0.6920730696828821 2.0093482385255546e-07 -0.0915861008427738 +1.0287 0.6920776657029368 0.6920774893557905 2.1220975411628817e-07 -0.09158854932759329 +1.0288 0.6920820896081126 0.6920819076521003 2.234257029179454e-07 -0.09159099713116658 +1.0289000000000001 0.6920865123721989 0.6920863245727913 2.3458020424055315e-07 -0.09159344425366504 +1.029 0.6920909339948573 0.6920907401188692 2.4567080618431714e-07 -0.09159589069525997 +1.0291000000000001 0.6920953544757236 0.6920951542913651 2.5669507152520366e-07 -0.0915983364561227 +1.0292000000000001 0.6920997738144081 0.6920995670913359 2.6765057823535665e-07 -0.0916007815364245 +1.0292999999999999 0.6921041920104951 0.6921039785198628 2.7853492003820923e-07 -0.09160322593633646 +1.0294 0.6921086090635444 0.6921083885780533 2.8934570688726735e-07 -0.09160566965602986 +1.0295 0.6921130249730909 0.692112797267039 3.000805655142824e-07 -0.09160811269567587 +1.0296 0.6921174397386436 0.6921172045879762 3.107371399843628e-07 -0.0916105550554455 +1.0297 0.6921218533596879 0.6921216105420458 3.2131309218169646e-07 -0.09161299673550989 +1.0298 0.6921262658356844 0.6921260151304535 3.318061023091512e-07 -0.09161543773604015 +1.0299 0.6921306771660692 0.6921304183544282 3.4221386945726406e-07 -0.09161787805720722 +1.03 0.6921350873502545 0.6921348202152238 3.5253411201363605e-07 -0.09162031769918211 +1.0301000000000002 0.6921394963876288 0.692139220714117 3.6276456825273806e-07 -0.09162275666213576 +1.0302 0.6921439042775566 0.6921436198524085 3.7290299680775574e-07 -0.0916251949462391 +1.0303 0.6921483110193793 0.6921480176314221 3.8294717711467863e-07 -0.09162763255166305 +1.0304 0.6921527166124147 0.6921524140525047 3.9289490995353393e-07 -0.09163006947857842 +1.0305 0.6921571210559583 0.6921568091170265 4.027440179202313e-07 -0.09163250572715612 +1.0306000000000002 0.692161524349282 0.6921612028263794 4.1249234589146866e-07 -0.09163494129756683 +1.0307 0.6921659264916358 0.6921655951819783 4.22137761503516e-07 -0.09163737618998138 +1.0308 0.6921703274822473 0.6921699861852595 4.316781556171212e-07 -0.09163981040457048 +1.0309000000000001 0.6921747273203218 0.6921743758376824 4.411114427615992e-07 -0.0916422439415048 +1.031 0.6921791260050434 0.6921787641407267 4.5043556162749354e-07 -0.09164467680095502 +1.0311000000000001 0.6921835235355744 0.6921831510958945 4.596484754898489e-07 -0.09164710898309181 +1.0312000000000001 0.6921879199110559 0.6921875367047082 4.6874817270781133e-07 -0.09164954048808571 +1.0312999999999999 0.6921923151306077 0.6921919209687115 4.777326670091231e-07 -0.09165197131610732 +1.0314 0.6921967091933295 0.6921963038894685 4.865999981840119e-07 -0.0916544014673272 +1.0315 0.6922011020983001 0.6922006854685636 4.953482322378466e-07 -0.09165683094191579 +1.0316 0.6922054938445784 0.6922050657076011 5.039754619601267e-07 -0.09165925974004357 +1.0317 0.6922098844312035 0.6922094446082052 5.124798073824488e-07 -0.09166168786188103 +1.0318 0.6922142738571944 0.692213822172019 5.208594160838187e-07 -0.09166411530759848 +1.0319 0.6922186621215516 0.6922181984007053 5.291124636902511e-07 -0.09166654207736633 +1.032 0.6922230492232562 0.6922225732959455 5.372371541106924e-07 -0.0916689681713549 +1.0321000000000002 0.6922274351612707 0.6922269468594398 5.452317201337653e-07 -0.09167139358973457 +1.0322 0.6922318199345394 0.6922313190929059 5.530944236636914e-07 -0.09167381833267552 +1.0323 0.692236203541988 0.6922356899980803 5.608235561643804e-07 -0.09167624240034804 +1.0324 0.6922405859825252 0.6922400595767162 5.684174390341301e-07 -0.09167866579292228 +1.0325 0.692244967255042 0.6922444278305846 5.758744239803271e-07 -0.09168108851056846 +1.0326000000000002 0.6922493473584121 0.6922487947614737 5.831928932692465e-07 -0.09168351055345673 +1.0327 0.6922537262914927 0.6922531603711879 5.903712602395306e-07 -0.09168593192175721 +1.0328 0.6922581040531245 0.6922575246615477 5.974079695658663e-07 -0.09168835261563996 +1.0329000000000002 0.6922624806421318 0.69226188763439 6.043014975226635e-07 -0.09169077263527502 +1.033 0.6922668560573237 0.6922662492915671 6.110503524281441e-07 -0.09169319198083241 +1.0331000000000001 0.6922712302974935 0.6922706096349465 6.176530749912867e-07 -0.0916956106524821 +1.0332000000000001 0.6922756033614191 0.6922749686664111 6.241082384644825e-07 -0.09169802865039402 +1.0332999999999999 0.6922799752478643 0.6922793263878579 6.304144491292574e-07 -0.09170044597473814 +1.0334 0.6922843459555783 0.6922836828011983 6.365703465321948e-07 -0.09170286262568429 +1.0335 0.6922887154832962 0.6922880379083576 6.425746037069802e-07 -0.09170527860340237 +1.0336 0.6922930838297392 0.6922923917112744 6.484259276046123e-07 -0.09170769390806213 +1.0337 0.6922974509936155 0.6922967442119012 6.541230592599367e-07 -0.09171010853983341 +1.0338 0.6923018169736201 0.6923010954122024 6.596647740414463e-07 -0.09171252249888591 +1.0339 0.6923061817684355 0.6923054453141555 6.650498820398587e-07 -0.09171493578538939 +1.034 0.6923105453767321 0.6923097939197497 6.702772281652614e-07 -0.09171734839951351 +1.0341000000000002 0.6923149077971684 0.6923141412309861 6.753456925634449e-07 -0.09171976034142797 +1.0342 0.6923192690283917 0.6923184872498773 6.802541907963144e-07 -0.09172217161130236 +1.0343 0.6923236290690372 0.6923228319784467 6.850016740223008e-07 -0.09172458220930632 +1.0344 0.6923279879177304 0.692327175418728 6.89587129232283e-07 -0.09172699213560935 +1.0345 0.6923323455730858 0.6923315175727656 6.940095795132661e-07 -0.091729401390381 +1.0346000000000002 0.6923367020337082 0.6923358584426131 6.982680842010369e-07 -0.09173180997379071 +1.0347 0.6923410572981931 0.6923401980303345 7.023617391160863e-07 -0.09173421788600802 +1.0348 0.692345411365126 0.6923445363380022 7.062896768134097e-07 -0.09173662512720235 +1.0349000000000002 0.6923497642330845 0.692348873367697 7.1005106662414e-07 -0.09173903169754304 +1.035 0.6923541159006369 0.6923532091215087 7.136451149747369e-07 -0.09174143759719948 +1.0351000000000001 0.6923584663663441 0.6923575436015343 7.17071065525765e-07 -0.09174384282634099 +1.0352000000000001 0.6923628156287591 0.6923618768098792 7.203281991441379e-07 -0.09174624738513687 +1.0352999999999999 0.6923671636864276 0.6923662087486548 7.234158343610853e-07 -0.09174865127375637 +1.0354 0.6923715105378887 0.6923705394199803 7.263333272750083e-07 -0.0917510544923688 +1.0355 0.6923758561816746 0.6923748688259801 7.29080071815158e-07 -0.09175345704114324 +1.0356 0.6923802006163121 0.6923791969687856 7.31655499852657e-07 -0.09175585892024894 +1.0357 0.6923845438403218 0.6923835238505329 7.340590812143777e-07 -0.09175826012985504 +1.0358 0.6923888858522191 0.6923878494733634 7.362903239466201e-07 -0.09176066067013057 +1.0359 0.6923932266505148 0.6923921738394235 7.383487743289896e-07 -0.09176306054124467 +1.036 0.6923975662337152 0.6923964969508638 7.402340169299082e-07 -0.09176545974336639 +1.0361000000000002 0.692401904600322 0.6924008188098383 7.419456747453923e-07 -0.09176785827666466 +1.0362 0.6924062417488341 0.6924051394185052 7.434834093239528e-07 -0.09177025614130845 +1.0363 0.6924105776777467 0.6924094587790257 7.448469207804731e-07 -0.09177265333746679 +1.0364 0.6924149123855524 0.692413776893563 7.460359477545753e-07 -0.09177504986530854 +1.0365 0.692419245870741 0.6924180937642835 7.470502676881763e-07 -0.09177744572500258 +1.0366000000000002 0.6924235781318007 0.6924224093933548 7.478896965756876e-07 -0.09177984091671779 +1.0367 0.6924279091672176 0.6924267237829461 7.485540892832043e-07 -0.0917822354406229 +1.0368 0.6924322389754773 0.6924310369352279 7.490433394652385e-07 -0.09178462929688674 +1.0369000000000002 0.6924365675550639 0.6924353488523709 7.493573794675745e-07 -0.091787022485678 +1.037 0.6924408949044615 0.6924396595365465 7.494961804521694e-07 -0.09178941500716545 +1.0371000000000001 0.6924452210221543 0.692443968989926 7.494597524387858e-07 -0.09179180686151778 +1.0372000000000001 0.6924495459066267 0.6924482772146796 7.492481441245813e-07 -0.0917941980489036 +1.0372999999999999 0.6924538695563638 0.6924525842129768 7.488614430228857e-07 -0.09179658856949154 +1.0374 0.6924581919698523 0.6924568899869857 7.482997754215681e-07 -0.09179897842345017 +1.0375 0.6924625131455805 0.6924611945388726 7.475633062165032e-07 -0.09180136761094804 +1.0376 0.6924668330820389 0.6924654978708014 7.46652239078105e-07 -0.0918037561321537 +1.0377 0.6924711517777201 0.6924697999849337 7.455668161043816e-07 -0.09180614398723562 +1.0378 0.6924754692311197 0.692474100883428 7.443073180984916e-07 -0.09180853117636223 +1.0379 0.6924797854407363 0.6924784005684391 7.428740642356768e-07 -0.09181091769970195 +1.038 0.6924841004050732 0.6924826990421185 7.412674121187734e-07 -0.09181330355742322 +1.0381000000000002 0.6924884141226365 0.6924869963066128 7.394877576810677e-07 -0.09181568874969435 +1.0382 0.6924927265919375 0.6924912923640647 7.375355349920065e-07 -0.09181807327668368 +1.0383 0.6924970378114923 0.692495587216611 7.354112162849535e-07 -0.09182045713855946 +1.0384 0.6925013477798223 0.6924998808663838 7.331153117073885e-07 -0.09182284033548997 +1.0385 0.6925056564954544 0.6925041733155093 7.306483693902965e-07 -0.09182522286764346 +1.0386000000000002 0.6925099639569217 0.6925084645661069 7.280109750734676e-07 -0.0918276047351881 +1.0387 0.692514270162764 0.69251275462029 7.252037522165189e-07 -0.09182998593829206 +1.0388 0.6925185751115277 0.6925170434801649 7.222273616935837e-07 -0.0918323664771235 +1.0389000000000002 0.6925228788017663 0.69252133114783 7.190825016406555e-07 -0.09183474635185046 +1.039 0.6925271812320417 0.6925256176253765 7.157699073723212e-07 -0.09183712556264104 +1.0391000000000001 0.6925314824009228 0.6925299029148866 7.122903511874723e-07 -0.09183950410966324 +1.0392000000000001 0.6925357823069878 0.6925341870184349 7.086446421472603e-07 -0.09184188199308507 +1.0393 0.692540080948823 0.6925384699380865 7.04833625977952e-07 -0.09184425921307449 +1.0394 0.6925443783250249 0.6925427516758974 7.008581847378625e-07 -0.09184663576979946 +1.0395 0.6925486744341985 0.6925470322339133 6.967192367202113e-07 -0.09184901166342785 +1.0396 0.6925529692749595 0.6925513116141708 6.924177361755657e-07 -0.09185138689412757 +1.0397 0.6925572628459337 0.6925555898186947 6.879546732563302e-07 -0.09185376146206642 +1.0398 0.6925615551457572 0.6925598668495001 6.833310735587794e-07 -0.0918561353674122 +1.0399 0.692565846173078 0.69256414270859 6.785479979704023e-07 -0.09185850861033268 +1.04 0.692570135926555 0.6925684173979565 6.736065425311244e-07 -0.0918608811909956 +1.0401000000000002 0.6925744244048591 0.6925726909195795 6.685078380586074e-07 -0.09186325310956867 +1.0402 0.6925787116066731 0.6925769632754264 6.632530500233491e-07 -0.09186562436621956 +1.0403 0.6925829975306927 0.6925812344674521 6.578433781045945e-07 -0.09186799496111593 +1.0404 0.6925872821756267 0.6925855044975985 6.522800559682906e-07 -0.0918703648944254 +1.0405 0.6925915655401964 0.6925897733677935 6.465643511283092e-07 -0.09187273416631547 +1.0406000000000002 0.6925958476231375 0.6925940410799523 6.406975645301127e-07 -0.09187510277695377 +1.0407 0.6926001284231991 0.6925983076359747 6.346810302870765e-07 -0.09187747072650773 +1.0408 0.6926044079391449 0.6926025730377474 6.285161153196661e-07 -0.09187983801514489 +1.0409000000000002 0.6926086861697531 0.6926068372871416 6.222042191889043e-07 -0.09188220464303269 +1.041 0.6926129631138171 0.6926111003860131 6.157467736522815e-07 -0.09188457061033854 +1.0411000000000001 0.6926172387701457 0.6926153623362028 6.091452423584442e-07 -0.0918869359172298 +1.0412000000000001 0.6926215131375626 0.6926196231395352 6.0240112056964e-07 -0.0918893005638738 +1.0413 0.6926257862149083 0.6926238827978193 5.955159347870165e-07 -0.09189166455043792 +1.0414 0.6926300580010395 0.6926281413128472 5.884912423897992e-07 -0.09189402787708939 +1.0415 0.6926343284948291 0.6926323986863947 5.813286313022248e-07 -0.09189639054399548 +1.0416 0.6926385976951674 0.6926366549202196 5.740297197298627e-07 -0.0918987525513234 +1.0417 0.6926428656009618 0.6926409100160635 5.665961554934817e-07 -0.09190111389924033 +1.0418 0.6926471322111374 0.6926451639756495 5.590296161539499e-07 -0.0919034745879135 +1.0419 0.6926513975246367 0.6926494168006824 5.513318080963003e-07 -0.09190583461750991 +1.042 0.6926556615404209 0.6926536684928495 5.435044665574873e-07 -0.09190819398819672 +1.0421 0.6926599242574694 0.6926579190538189 5.355493550296409e-07 -0.09191055270014098 +1.0422 0.6926641856747808 0.6926621684852399 5.27468264871489e-07 -0.0919129107535097 +1.0423 0.6926684457913723 0.6926664167887426 5.192630149891686e-07 -0.09191526814846984 +1.0424 0.6926727046062806 0.6926706639659379 5.109354513643805e-07 -0.09191762488518841 +1.0425 0.692676962118562 0.6926749100184162 5.024874466658114e-07 -0.09191998096383233 +1.0426000000000002 0.6926812183272929 0.6926791549477487 4.93920899860556e-07 -0.09192233638456847 +1.0427 0.6926854732315697 0.6926833987554857 4.852377356312498e-07 -0.09192469114756374 +1.0428 0.6926897268305092 0.6926876414431572 4.7643990420953575e-07 -0.09192704525298492 +1.0429000000000002 0.6926939791232488 0.6926918830122719 4.6752938066829675e-07 -0.09192939870099878 +1.043 0.6926982301089473 0.6926961234643181 4.5850816467185584e-07 -0.09193175149177214 +1.0431000000000001 0.6927024797867845 0.6927003628007622 4.493782799902535e-07 -0.09193410362547172 +1.0432000000000001 0.6927067281559615 0.6927046010230491 4.4014177391638043e-07 -0.09193645510226421 +1.0433 0.6927109752157014 0.6927088381326016 4.3080071700229983e-07 -0.09193880592231625 +1.0434 0.692715220965249 0.6927130741308212 4.2135720239311336e-07 -0.09194115608579453 +1.0435 0.6927194654038716 0.6927173090190859 4.118133455424666e-07 -0.09194350559286563 +1.0436 0.6927237085308589 0.6927215427987523 4.021712836504987e-07 -0.09194585444369612 +1.0437 0.6927279503455225 0.6927257754711533 3.924331751989363e-07 -0.09194820263845249 +1.0438 0.6927321908471977 0.6927300070375997 3.826011994514933e-07 -0.0919505501773013 +1.0439 0.6927364300352429 0.6927342374993779 3.72677555988965e-07 -0.09195289706040906 +1.044 0.6927406679090391 0.6927384668577519 3.6266446418881104e-07 -0.0919552432879421 +1.0441 0.6927449044679914 0.6927426951139614 3.5256416277412717e-07 -0.09195758886006689 +1.0442 0.6927491397115282 0.6927469222692226 3.4237890927935055e-07 -0.09195993377694978 +1.0443 0.692753373639102 0.6927511483247277 3.321109795506594e-07 -0.09196227803875712 +1.0444 0.6927576062501897 0.6927553732816447 3.217626672463725e-07 -0.09196462164565522 +1.0445 0.6927618375442914 0.6927595971411169 3.113362833304101e-07 -0.09196696459781037 +1.0446000000000002 0.6927660675209328 0.6927638199042636 3.0083415554493786e-07 -0.09196930689538879 +1.0447 0.6927702961796636 0.6927680415721786 2.902586279315833e-07 -0.09197164853855674 +1.0448 0.6927745235200582 0.6927722621459316 2.79612060220813e-07 -0.09197398952748036 +1.0449000000000002 0.6927787495417159 0.6927764816265664 2.688968273600878e-07 -0.09197632986232578 +1.045 0.6927829742442617 0.6927807000151021 2.581153189865071e-07 -0.09197866954325912 +1.0451000000000001 0.692787197627345 0.6927849173125322 2.472699389063915e-07 -0.09198100857044642 +1.0452000000000001 0.6927914196906413 0.6927891335198251 2.363631045401715e-07 -0.09198334694405384 +1.0453 0.6927956404338509 0.6927933486379232 2.2539724640197045e-07 -0.09198568466424734 +1.0454 0.6927998598567006 0.6927975626677433 2.1437480748204285e-07 -0.09198802173119291 +1.0455 0.6928040779589419 0.6928017756101758 2.0329824283044085e-07 -0.09199035814505652 +1.0456 0.6928082947403532 0.6928059874660857 1.9217001888394147e-07 -0.09199269390600405 +1.0457 0.6928125102007383 0.6928101982363113 1.809926130323658e-07 -0.0919950290142014 +1.0458 0.6928167243399272 0.6928144079216649 1.6976851300101736e-07 -0.0919973634698144 +1.0459 0.6928209371577765 0.6928186165229329 1.5850021627475397e-07 -0.09199969727300893 +1.046 0.6928251486541683 0.6928228240408745 1.471902295949179e-07 -0.09200203042395076 +1.0461 0.6928293588290122 0.6928270304762223 1.358410683903466e-07 -0.09200436292280562 +1.0462 0.6928335676822431 0.6928312358296829 1.2445525621185283e-07 -0.09200669476973922 +1.0463 0.6928377752138236 0.6928354401019361 1.1303532414935757e-07 -0.0920090259649173 +1.0464 0.6928419814237422 0.6928396432936345 1.0158381031147301e-07 -0.09201135650850552 +1.0465 0.6928461863120143 0.692843845405404 9.010325923222706e-08 -0.09201368640066948 +1.0466000000000002 0.6928503898786822 0.6928480464378435 7.859622131248245e-08 -0.09201601564157474 +1.0467 0.692854592123815 0.6928522463915252 6.706525225615156e-08 -0.09201834423138697 +1.0468 0.6928587930475084 0.6928564452669944 5.5512912509880774e-08 -0.09202067217027166 +1.0469000000000002 0.6928629926498853 0.6928606430647685 4.394176666110139e-08 -0.09202299945839422 +1.047 0.6928671909310957 0.6928648397853387 3.2354382929755676e-08 -0.0920253260959202 +1.0471000000000001 0.6928713878913162 0.6928690354291684 2.0753332531653346e-08 -0.09202765208301501 +1.0472000000000001 0.6928755835307506 0.6928732299966944 9.141189160656593e-09 -0.09202997741984403 +1.0473 0.6928797778496301 0.6928774234883259 -2.479471621942564e-09 -0.09203230210657268 +1.0474 0.6928839708482123 0.6928816159044453 -1.4106072926053925e-08 -0.09203462614336626 +1.0475 0.6928881625267822 0.692885807245407 -2.5736037124329814e-08 -0.09203694953039004 +1.0476 0.6928923528856521 0.6928899975115392 -3.736678641898597e-08 -0.09203927226780939 +1.0477 0.6928965419251608 0.6928941867031422 -4.8995743411278745e-08 -0.09204159435578942 +1.0478 0.6929007296456746 0.6928983748204893 -6.062033167152439e-08 -0.0920439157944954 +1.0479 0.6929049160475867 0.6929025618638267 -7.223797631340095e-08 -0.09204623658409253 +1.048 0.6929091011313175 0.6929067478333735 -8.384610456543123e-08 -0.09204855672474589 +1.0481 0.6929132848973139 0.6929109327293212 -9.544214633113585e-08 -0.09205087621662066 +1.0482 0.6929174673460503 0.692915116551835 -1.0702353477141241e-07 -0.09205319505988185 +1.0483 0.6929216484780275 0.6929192993010522 -1.1858770686441755e-07 -0.09205551325469452 +1.0484 0.6929258282937734 0.6929234809770837 -1.3013210397629094e-07 -0.09205783080122365 +1.0485 0.6929300067938433 0.6929276615800132 -1.4165417242147094e-07 -0.09206014769963433 +1.0486000000000002 0.6929341839788182 0.6929318411098975 -1.5315136403862284e-07 -0.09206246395009138 +1.0487 0.6929383598493064 0.6929360195667664 -1.6462113675008716e-07 -0.09206477955275977 +1.0488 0.692942534405943 0.6929401969506237 -1.7606095510658282e-07 -0.09206709450780444 +1.0489000000000002 0.6929467076493889 0.6929443732614453 -1.87468290883952e-07 -0.09206940881539012 +1.049 0.6929508795803321 0.6929485484991814 -1.9884062359490362e-07 -0.0920717224756817 +1.0491000000000001 0.6929550501994869 0.6929527226637553 -2.101754410892276e-07 -0.09207403548884394 +1.0492000000000001 0.6929592195075936 0.6929568957550641 -2.2147024010543692e-07 -0.0920763478550416 +1.0493 0.6929633875054191 0.6929610677729783 -2.3272252677730698e-07 -0.09207865957443934 +1.0494 0.6929675541937559 0.6929652387173422 -2.4392981726184537e-07 -0.0920809706472019 +1.0495 0.6929717195734231 0.6929694085879745 -2.5508963819725894e-07 -0.092083281073494 +1.0496 0.6929758836452649 0.692973577384667 -2.661995273239848e-07 -0.09208559085348016 +1.0497 0.6929800464101517 0.6929777451071866 -2.7725703399122947e-07 -0.09208789998732497 +1.0497999999999998 0.6929842078689796 0.6929819117552736 -2.8825971970514175e-07 -0.09209020847519306 +1.0499 0.69298836802267 0.6929860773286433 -2.9920515865616837e-07 -0.09209251631724891 +1.05 0.6929925268721693 0.6929902418269851 -3.1009093828804346e-07 -0.092094823513657 +1.0501 0.6929966844184496 0.6929944052499631 -3.2091465982514444e-07 -0.09209713006458176 +1.0502 0.6930008406625081 0.6929985675972168 -3.3167393871658124e-07 -0.09209943597018772 +1.0503 0.6930049956053663 0.69300272886836 -3.423664053162079e-07 -0.09210174123063919 +1.0504 0.6930091492480707 0.6930068890629819 -3.5298970524344497e-07 -0.09210404584610053 +1.0505 0.6930133015916925 0.6930110481806468 -3.635414999939024e-07 -0.0921063498167361 +1.0506000000000002 0.6930174526373272 0.6930152062208947 -3.74019467480613e-07 -0.09210865314271019 +1.0507 0.6930216023860944 0.6930193631832415 -3.844213024364884e-07 -0.09211095582418707 +1.0508 0.693025750839138 0.6930235190671787 -3.947447170526974e-07 -0.09211325786133098 +1.0509000000000002 0.6930298979976255 0.6930276738721732 -4.0498744136724385e-07 -0.0921155592543061 +1.051 0.6930340438627478 0.6930318275976692 -4.1514722384783376e-07 -0.09211786000327658 +1.0511000000000001 0.6930381884357197 0.6930359802430868 -4.2522183179433126e-07 -0.09212016010840662 +1.0512000000000001 0.6930423317177791 0.6930401318078223 -4.3520905200489235e-07 -0.09212245956986026 +1.0513 0.6930464737101866 0.6930442822912495 -4.4510669101188727e-07 -0.09212475838780154 +1.0514000000000001 0.6930506144142261 0.6930484316927191 -4.549125757827288e-07 -0.09212705656239462 +1.0515 0.6930547538312041 0.6930525800115588 -4.646245541015115e-07 -0.09212935409380338 +1.0516 0.6930588919624489 0.6930567272470738 -4.742404950269785e-07 -0.09213165098219186 +1.0517 0.6930630288093114 0.6930608733985475 -4.837582893921222e-07 -0.09213394722772401 +1.0517999999999998 0.693067164373164 0.6930650184652408 -4.931758503037842e-07 -0.09213624283056365 +1.0519 0.6930712986554015 0.6930691624463928 -5.024911134826615e-07 -0.09213853779087477 +1.052 0.6930754316574392 0.693073305341221 -5.117020379086235e-07 -0.0921408321088211 +1.0521 0.6930795633807144 0.6930774471489222 -5.208066060358174e-07 -0.09214312578456652 +1.0522 0.6930836938266851 0.6930815878686714 -5.298028243755359e-07 -0.09214541881827483 +1.0523 0.6930878229968296 0.6930857274996229 -5.386887239750004e-07 -0.09214771121010974 +1.0524 0.693091950892647 0.6930898660409106 -5.474623607226725e-07 -0.09215000296023498 +1.0525 0.6930960775156562 0.6930940034916482 -5.56121815861732e-07 -0.0921522940688142 +1.0526000000000002 0.6931002028673963 0.693098139850929 -5.646651964064109e-07 -0.092154584536011 +1.0527 0.6931043269494255 0.6931022751178273 -5.730906354889376e-07 -0.0921568743619891 +1.0528 0.6931084497633221 0.6931064092913972 -5.813962927619931e-07 -0.09215916354691203 +1.0529000000000002 0.6931125713106827 0.693110542370674 -5.895803549677003e-07 -0.09216145209094334 +1.053 0.6931166915931233 0.6931146743546743 -5.976410361319129e-07 -0.09216373999424661 +1.0531000000000001 0.6931208106122775 0.6931188052423958 -6.055765781193267e-07 -0.09216602725698525 +1.0532000000000001 0.6931249283697979 0.6931229350328176 -6.133852508694027e-07 -0.09216831387932278 +1.0533 0.693129044867354 0.6931270637249014 -6.210653528959664e-07 -0.09217059986142251 +1.0534000000000001 0.693133160106634 0.6931311913175913 -6.286152115370092e-07 -0.09217288520344796 +1.0535 0.6931372740893422 0.6931353178098131 -6.36033183426532e-07 -0.09217516990556238 +1.0536 0.6931413868172007 0.6931394432004765 -6.43317654772102e-07 -0.09217745396792913 +1.0537 0.6931454982919478 0.693143567488474 -6.504670419099634e-07 -0.09217973739071156 +1.0537999999999998 0.6931496085153381 0.6931476906726819 -6.574797912772823e-07 -0.09218202017407279 +1.0539 0.6931537174891427 0.6931518127519601 -6.643543800644025e-07 -0.09218430231817626 +1.054 0.6931578252151475 0.6931559337251529 -6.710893164646459e-07 -0.09218658382318501 +1.0541 0.6931619316951539 0.6931600535910891 -6.776831399241123e-07 -0.09218886468926224 +1.0542 0.6931660369309789 0.6931641723485822 -6.841344215163803e-07 -0.09219114491657106 +1.0543 0.6931701409244533 0.6931682899964313 -6.904417643172067e-07 -0.09219342450527457 +1.0544 0.6931742436774228 0.6931724065334207 -6.966038035571831e-07 -0.09219570345553585 +1.0545 0.6931783451917468 0.6931765219583206 -7.026192070797022e-07 -0.09219798176751791 +1.0546000000000002 0.6931824454692987 0.693180636269888 -7.084866754797359e-07 -0.09220025944138381 +1.0547 0.6931865445119645 0.6931847494668656 -7.142049424646579e-07 -0.09220253647729644 +1.0548 0.6931906423216436 0.6931888615479838 -7.197727751317995e-07 -0.09220481287541878 +1.0549000000000002 0.6931947389002482 0.6931929725119597 -7.251889742182493e-07 -0.09220708863591373 +1.055 0.6931988342497017 0.6931970823574984 -7.304523743506541e-07 -0.09220936375894412 +1.0551000000000001 0.6932029283719401 0.6932011910832931 -7.355618443088963e-07 -0.0922116382446728 +1.0552000000000001 0.6932070212689111 0.6932052986880253 -7.405162873452831e-07 -0.09221391209326257 +1.0553 0.6932111129425733 0.6932094051703651 -7.453146412261802e-07 -0.09221618530487634 +1.0554000000000001 0.6932152033948957 0.6932135105289718 -7.499558786899785e-07 -0.09221845787967671 +1.0555 0.693219292627858 0.693217614762494 -7.544390074609719e-07 -0.09222072981782642 +1.0556 0.6932233806434496 0.6932217178695703 -7.587630705963022e-07 -0.09222300111948811 +1.0557 0.69322746744367 0.6932258198488297 -7.629271466941256e-07 -0.09222527178482448 +1.0557999999999998 0.6932315530305277 0.6932299206988914 -7.66930349963002e-07 -0.09222754181399812 +1.0559 0.6932356374060403 0.693234020418366 -7.707718305133282e-07 -0.09222981120717161 +1.056 0.6932397205722335 0.693238119005855 -7.744507746071383e-07 -0.0922320799645075 +1.0561 0.6932438025311414 0.6932422164599519 -7.779664046442258e-07 -0.09223434808616829 +1.0562 0.6932478832848055 0.6932463127792423 -7.813179795229663e-07 -0.09223661557231644 +1.0563 0.6932519628352751 0.6932504079623045 -7.845047946125616e-07 -0.09223888242311445 +1.0564 0.6932560411846063 0.6932545020077091 -7.875261819889623e-07 -0.09224114863872465 +1.0565 0.6932601183348619 0.6932585949140206 -7.903815106846679e-07 -0.09224341421930951 +1.0566000000000002 0.6932641942881108 0.6932626866797971 -7.930701866193379e-07 -0.09224567916503136 +1.0567 0.6932682690464276 0.6932667773035903 -7.955916528357143e-07 -0.09224794347605256 +1.0568 0.6932723426118923 0.6932708667839469 -7.979453896106437e-07 -0.09225020715253536 +1.0569000000000002 0.6932764149865902 0.693274955119408 -8.00130914468955e-07 -0.09225247019464203 +1.057 0.6932804861726105 0.69327904230851 -8.021477824887713e-07 -0.09225473260253472 +1.0571000000000002 0.6932845561720475 0.6932831283497853 -8.039955862182424e-07 -0.09225699437637569 +1.0572000000000001 0.693288624986999 0.693287213241762 -8.056739558004455e-07 -0.09225925551632708 +1.0573 0.6932926926195659 0.6932912969829649 -8.071825590427739e-07 -0.09226151602255103 +1.0574000000000001 0.6932967590718524 0.6932953795719152 -8.085211015002036e-07 -0.09226377589520961 +1.0575 0.6933008243459657 0.6932994610071317 -8.096893265308047e-07 -0.09226603513446491 +1.0576 0.6933048884440146 0.6933035412871305 -8.106870152957413e-07 -0.0922682937404789 +1.0577 0.6933089513681101 0.6933076204104258 -8.115139868702936e-07 -0.09227055171341364 +1.0577999999999999 0.6933130131203644 0.6933116983755307 -8.121700982854918e-07 -0.09227280905343105 +1.0579 0.6933170737028911 0.6933157751809567 -8.126552445142377e-07 -0.09227506576069308 +1.058 0.6933211331178041 0.6933198508252142 -8.129693584574271e-07 -0.09227732183536164 +1.0581 0.6933251913672176 0.6933239253068139 -8.13112410957828e-07 -0.09227957727759856 +1.0582 0.6933292484532458 0.693327998624266 -8.130844108139579e-07 -0.09228183208756569 +1.0583 0.6933333043780023 0.6933320707760815 -8.128854048078393e-07 -0.09228408626542484 +1.0584 0.6933373591435998 0.6933361417607722 -8.125154776772447e-07 -0.09228633981133783 +1.0585 0.6933414127521492 0.6933402115768506 -8.11974752060185e-07 -0.0922885927254663 +1.0586000000000002 0.69334546520576 0.6933442802228313 -8.112633884393983e-07 -0.09229084500797202 +1.0587 0.6933495165065398 0.6933483476972306 -8.103815851145946e-07 -0.09229309665901662 +1.0588 0.6933535666565929 0.6933524139985675 -8.093295782163334e-07 -0.09229534767876173 +1.0589000000000002 0.6933576156580212 0.6933564791253639 -8.081076415533683e-07 -0.09229759806736898 +1.059 0.6933616635129235 0.6933605430761446 -8.067160865710132e-07 -0.09229984782499999 +1.0591000000000002 0.6933657102233943 0.693364605849438 -8.051552622817537e-07 -0.09230209695181625 +1.0592000000000001 0.6933697557915242 0.6933686674437768 -8.034255551819802e-07 -0.0923043454479793 +1.0593 0.6933738002193989 0.6933727278576979 -8.015273892242325e-07 -0.0923065933136506 +1.0594000000000001 0.6933778435090997 0.6933767870897428 -7.994612255812772e-07 -0.09230884054899156 +1.0595 0.6933818856627025 0.6933808451384587 -7.9722756263223e-07 -0.09231108715416367 +1.0596 0.693385926682277 0.6933849020023977 -7.948269357682669e-07 -0.09231333312932825 +1.0597 0.6933899665698877 0.6933889576801184 -7.922599174065015e-07 -0.09231557847464668 +1.0597999999999999 0.6933940053275917 0.6933930121701856 -7.895271166569184e-07 -0.09231782319028027 +1.0599 0.6933980429574396 0.6933970654711704 -7.866291793778846e-07 -0.09232006727639025 +1.06 0.6934020794614747 0.6934011175816519 -7.835667878569597e-07 -0.09232231073313796 +1.0601 0.6934061148417329 0.6934051685002156 -7.803406607692631e-07 -0.09232455356068457 +1.0602 0.6934101491002418 0.6934092182254561 -7.769515529554294e-07 -0.09232679575919127 +1.0603 0.6934141822390205 0.6934132667559751 -7.734002552273189e-07 -0.09232903732881921 +1.0604 0.6934182142600799 0.6934173140903837 -7.696875942708736e-07 -0.09233127826972952 +1.0605 0.6934222451654208 0.6934213602273018 -7.658144323408056e-07 -0.09233351858208329 +1.0606000000000002 0.6934262749570357 0.6934254051653587 -7.617816671773303e-07 -0.0923357582660416 +1.0607 0.6934303036369059 0.6934294489031931 -7.575902317424887e-07 -0.09233799732176544 +1.0608 0.6934343312070035 0.6934334914394547 -7.53241093914836e-07 -0.09234023574941584 +1.0609000000000002 0.693438357669289 0.6934375327728025 -7.487352564200522e-07 -0.0923424735491537 +1.061 0.6934423830257128 0.6934415729019074 -7.44073756567265e-07 -0.09234471072113999 +1.0611000000000002 0.6934464072782133 0.693445611825451 -7.392576659576156e-07 -0.09234694726553559 +1.0612000000000001 0.6934504304287177 0.6934496495421263 -7.342880902483362e-07 -0.09234918318250136 +1.0613 0.6934544524791408 0.693453686050639 -7.291661689584616e-07 -0.09235141847219819 +1.0614000000000001 0.6934584734313851 0.6934577213497064 -7.238930750941286e-07 -0.09235365313478681 +1.0615 0.69346249328734 0.6934617554380585 -7.184700149681644e-07 -0.09235588717042802 +1.0616 0.6934665120488823 0.6934657883144384 -7.128982279919205e-07 -0.0923581205792825 +1.0617 0.6934705297178748 0.6934698199776028 -7.071789861895494e-07 -0.09236035336151104 +1.0617999999999999 0.693474546296167 0.6934738504263218 -7.013135941147386e-07 -0.09236258551727426 +1.0619 0.6934785617855936 0.6934778796593792 -6.953033884343762e-07 -0.09236481704673273 +1.062 0.6934825761879757 0.693481907675574 -6.89149737706507e-07 -0.09236704795004722 +1.0621 0.6934865895051187 0.693485934473719 -6.828540419362428e-07 -0.09236927822737816 +1.0622 0.6934906017388132 0.6934899600526423 -6.764177323953513e-07 -0.09237150787888611 +1.0623 0.6934946128908346 0.6934939844111876 -6.69842271316945e-07 -0.09237373690473162 +1.0624 0.6934986229629421 0.6934980075482142 -6.63129151354247e-07 -0.09237596530507518 +1.0625 0.6935026319568788 0.6935020294625969 -6.562798954556914e-07 -0.09237819308007715 +1.0626000000000002 0.6935066398743717 0.6935060501532271 -6.49296056476345e-07 -0.092380420229898 +1.0627 0.6935106467171308 0.6935100696190131 -6.421792167476958e-07 -0.0923826467546981 +1.0628 0.6935146524868492 0.6935140878588797 -6.349309877862197e-07 -0.09238487265463777 +1.0629000000000002 0.6935186571852023 0.6935181048717691 -6.275530099048021e-07 -0.09238709792987737 +1.063 0.6935226608138484 0.6935221206566409 -6.200469518796714e-07 -0.09238932258057717 +1.0631000000000002 0.6935266633744274 0.6935261352124729 -6.124145105063095e-07 -0.09239154660689743 +1.0632000000000001 0.693530664868561 0.6935301485382601 -6.046574102941404e-07 -0.09239377000899832 +1.0633 0.6935346652978523 0.6935341606330165 -5.96777402994686e-07 -0.09239599278704 +1.0634000000000001 0.6935386646638864 0.6935381714957753 -5.887762672684982e-07 -0.09239821494118272 +1.0635 0.6935426629682281 0.6935421811255877 -5.806558083243374e-07 -0.09240043647158654 +1.0636 0.6935466602124234 0.6935461895215246 -5.724178573363048e-07 -0.09240265737841155 +1.0637 0.6935506563979992 0.6935501966826763 -5.640642712495536e-07 -0.09240487766181786 +1.0637999999999999 0.6935546515264615 0.6935542026081527 -5.555969322390553e-07 -0.09240709732196543 +1.0639 0.6935586455992965 0.6935582072970838 -5.470177472655102e-07 -0.09240931635901423 +1.064 0.6935626386179702 0.6935622107486202 -5.383286477839144e-07 -0.09241153477312422 +1.0641 0.6935666305839279 0.6935662129619327 -5.295315890913033e-07 -0.09241375256445539 +1.0642 0.693570621498594 0.6935702139362129 -5.206285501116459e-07 -0.09241596973316758 +1.0643 0.6935746113633714 0.6935742136706737 -5.11621532819917e-07 -0.09241818627942072 +1.0644 0.6935786001796418 0.693578212164549 -5.025125618673965e-07 -0.09242040220337455 +1.0645 0.6935825879487653 0.693582209417094 -4.933036839988025e-07 -0.09242261750518892 +1.0646000000000002 0.69358657467208 0.6935862054275862 -4.839969677400413e-07 -0.09242483218502355 +1.0647 0.6935905603509018 0.6935902001953247 -4.745945028708509e-07 -0.09242704624303821 +1.0648 0.6935945449865251 0.6935941937196308 -4.65098399939079e-07 -0.09242925967939261 +1.0649000000000002 0.6935985285802209 0.6935981859998481 -4.555107898096544e-07 -0.09243147249424642 +1.065 0.6936025111332375 0.6936021770353432 -4.4583382322049836e-07 -0.09243368468775925 +1.0651000000000002 0.6936064926468006 0.6936061668255047 -4.360696702065958e-07 -0.0924358962600907 +1.0652000000000001 0.6936104731221127 0.6936101553697451 -4.262205197183566e-07 -0.09243810721140035 +1.0653 0.6936144525603529 0.6936141426674993 -4.1628857904568717e-07 -0.09244031754184773 +1.0654000000000001 0.6936184309626766 0.6936181287182263 -4.0627607340165683e-07 -0.09244252725159234 +1.0655 0.693622408330216 0.6936221135214082 -3.96185245395142e-07 -0.0924447363407937 +1.0656 0.693626384664079 0.6936260970765509 -3.8601835444795896e-07 -0.09244694480961119 +1.0657 0.6936303599653495 0.6936300793831842 -3.757776764340415e-07 -0.09244915265820425 +1.0657999999999999 0.6936343342350872 0.6936340604408622 -3.654655030688181e-07 -0.09245135988673227 +1.0659 0.6936383074743275 0.6936380402491631 -3.5508414140961175e-07 -0.09245356649535456 +1.066 0.693642279684081 0.6936420188076893 -3.4463591339767286e-07 -0.09245577248423043 +1.0661 0.6936462508653343 0.6936459961160681 -3.341231552614343e-07 -0.09245797785351918 +1.0662 0.6936502210190482 0.6936499721739515 -3.2354821703078906e-07 -0.09246018260338011 +1.0663 0.693654190146159 0.6936539469810161 -3.129134620652452e-07 -0.09246238673397233 +1.0664 0.693658158247578 0.6936579205369633 -3.022212664155477e-07 -0.09246459024545507 +1.0665 0.6936621253241915 0.69366189284152 -2.9147401832407827e-07 -0.0924667931379875 +1.0666000000000002 0.6936660913768595 0.6936658638944382 -2.806741178189298e-07 -0.09246899541172873 +1.0667 0.6936700564064172 0.6936698336954953 -2.698239759853227e-07 -0.09247119706683782 +1.0668 0.6936740204136744 0.6936738022444939 -2.589260145909045e-07 -0.09247339810347385 +1.0669000000000002 0.6936779833994149 0.6936777695412624 -2.479826653918604e-07 -0.09247559852179586 +1.067 0.6936819453643962 0.6936817355856549 -2.3699636974780502e-07 -0.09247779832196279 +1.0671000000000002 0.6936859063093506 0.6936857003775511 -2.2596957797646477e-07 -0.09247999750413362 +1.0672000000000001 0.6936898662349844 0.6936896639168564 -2.1490474881591393e-07 -0.09248219606846728 +1.0673 0.6936938251419777 0.6936936262035024 -2.0380434891803523e-07 -0.09248439401512265 +1.0674000000000001 0.6936977830309842 0.6936975872374468 -1.9267085226912228e-07 -0.09248659134425861 +1.0675 0.6937017399026315 0.6937015470186729 -1.815067396382375e-07 -0.09248878805603399 +1.0676 0.6937056957575212 0.6937055055471907 -1.7031449802903942e-07 -0.09249098415060754 +1.0677 0.6937096505962284 0.693709462823036 -1.5909662015242687e-07 -0.09249317962813808 +1.0677999999999999 0.6937136044193015 0.6937134188462708 -1.4785560381765095e-07 -0.0924953744887843 +1.0679 0.6937175572272631 0.6937173736169842 -1.3659395142404107e-07 -0.09249756873270495 +1.068 0.6937215090206084 0.6937213271352904 -1.2531416937466844e-07 -0.09249976236005863 +1.0681 0.693725459799807 0.6937252794013311 -1.140187675420512e-07 -0.09250195537100403 +1.0682 0.6937294095653013 0.6937292304152735 -1.0271025868181793e-07 -0.0925041477656997 +1.0683 0.6937333583175074 0.6937331801773121 -9.139115790621904e-08 -0.09250633954430426 +1.0684 0.693737306056815 0.6937371286876672 -8.006398210212706e-08 -0.09250853070697623 +1.0685 0.6937412527835867 0.6937410759465861 -6.873124937679248e-08 -0.09251072125387415 +1.0686000000000002 0.6937451984981586 0.693745021954342 -5.739547850056384e-08 -0.09251291118515642 +1.0687 0.6937491432008407 0.6937489667112349 -4.6059188339849996e-08 -0.09251510050098152 +1.0688 0.6937530868919155 0.6937529102175912 -3.4724897312471154e-08 -0.09251728920150781 +1.0689000000000002 0.69375702957164 0.6937568524737642 -2.3395122812326988e-08 -0.0925194772868938 +1.069 0.6937609712402435 0.6937607934801328 -1.2072380659380877e-08 -0.09252166475729767 +1.0691000000000002 0.6937649118979291 0.693764733237103 -7.591845390189644e-10 -0.0925238516128778 +1.0692000000000002 0.693768851544874 0.693768671745107 1.0541954556693434e-08 -0.0925260378537925 +1.0693 0.6937727901812281 0.6937726090046034 2.1828528887213317e-08 -0.09252822348020001 +1.0694000000000001 0.6937767278071151 0.6937765450160771 3.309803451451154e-08 -0.09253040849225852 +1.0695 0.6937806644226323 0.6937804797800389 4.434797186772532e-08 -0.09253259289012622 +1.0696 0.6937846000278507 0.6937844132970263 5.5575846293065556e-08 -0.09253477667396123 +1.0697 0.6937885346228148 0.6937883455676035 6.67791686011221e-08 -0.09253695984392177 +1.0697999999999999 0.6937924682075431 0.6937922765923594 7.795545562891415e-08 -0.09253914240016581 +1.0699 0.6937964007820279 0.6937962063719101 8.91022307880629e-08 -0.09254132434285148 +1.07 0.693800332346235 0.6938001349068968 1.0021702460949466e-07 -0.09254350567213676 +1.0701 0.6938042629001047 0.6938040621979875 1.1129737529161354e-07 -0.09254568638817963 +1.0702 0.6938081924435509 0.6938079882458754 1.2234082923806566e-07 -0.09254786649113808 +1.0703 0.6938121209764623 0.6938119130512794 1.3334494163019794e-07 -0.09255004598117007 +1.0704 0.6938160484987013 0.6938158366149443 1.4430727692665846e-07 -0.09255222485843345 +1.0705 0.6938199750101044 0.69381975893764 1.5522540944279406e-07 -0.09255440312308603 +1.0706000000000002 0.6938239005104833 0.6938236800201623 1.6609692384331187e-07 -0.0925565807752857 +1.0707 0.6938278249996239 0.6938275998633319 1.7691941573208525e-07 -0.09255875781519025 +1.0708 0.6938317484772869 0.6938315184679946 1.8769049213787636e-07 -0.09256093424295744 +1.0709000000000002 0.6938356709432079 0.6938354358350218 1.9840777205903937e-07 -0.092563110058745 +1.071 0.6938395923970972 0.6938393519653089 2.0906888700475412e-07 -0.09256528526271063 +1.0711000000000002 0.6938435128386407 0.6938432668597766 2.1967148148421822e-07 -0.092567459855012 +1.0712000000000002 0.6938474322674986 0.6938471805193707 2.302132135617585e-07 -0.09256963383580676 +1.0713 0.6938513506833075 0.6938510929450603 2.4069175535990084e-07 -0.09257180720525247 +1.0714000000000001 0.6938552680856789 0.69385500413784 2.5110479358325666e-07 -0.09257397996350675 +1.0715 0.6938591844742004 0.6938589140987275 2.6145002999383715e-07 -0.09257615211072712 +1.0716 0.6938630998484352 0.6938628228287653 2.717251819453481e-07 -0.0925783236470711 +1.0717 0.6938670142079224 0.6938667303290195 2.8192798293136256e-07 -0.09258049457269607 +1.0717999999999999 0.6938709275521777 0.6938706366005793 2.9205618301553216e-07 -0.09258266488775957 +1.0719 0.6938748398806935 0.6938745416445585 3.0210754933118755e-07 -0.09258483459241901 +1.072 0.6938787511929376 0.693878445462093 3.1207986661563325e-07 -0.09258700368683172 +1.0721 0.6938826614883555 0.6938823480543427 3.2197093768893126e-07 -0.09258917217115507 +1.0722 0.6938865707663696 0.69388624942249 3.31778583918807e-07 -0.0925913400455464 +1.0723 0.6938904790263791 0.6938901495677399 3.415006457480052e-07 -0.09259350731016297 +1.0724 0.6938943862677609 0.6938940484913199 3.511349830412347e-07 -0.092595673965162 +1.0725 0.6938982924898693 0.6938979461944801 3.6067947572354653e-07 -0.09259784001070075 +1.0726000000000002 0.6939021976920362 0.6939018426784924 3.7013202414115653e-07 -0.09260000544693636 +1.0727 0.6939061018735719 0.6939057379446506 3.794905496165568e-07 -0.09260217027402602 +1.0728 0.6939100050337648 0.6939096319942701 3.8875299476076597e-07 -0.0926043344921268 +1.0729000000000002 0.6939139071718818 0.6939135248286878 3.979173240492573e-07 -0.09260649810139587 +1.073 0.6939178082871682 0.6939174164492616 4.069815242174757e-07 -0.0926086611019902 +1.0731000000000002 0.6939217083788487 0.6939213068573704 4.1594360473962144e-07 -0.09261082349406685 +1.0732000000000002 0.6939256074461272 0.6939251960544137 4.248015981686559e-07 -0.09261298527778283 +1.0733 0.6939295054881863 0.693929084041812 4.33553560767741e-07 -0.0926151464532951 +1.0734000000000001 0.6939334025041893 0.6939329708210047 4.4219757273228355e-07 -0.09261730702076056 +1.0735 0.6939372984932788 0.6939368563934522 4.507317386687193e-07 -0.09261946698033609 +1.0736 0.6939411934545774 0.6939407407606342 4.591541880871741e-07 -0.09262162633217857 +1.0737 0.6939450873871891 0.6939446239240501 4.6746307573453105e-07 -0.09262378507644488 +1.0737999999999999 0.6939489802901977 0.693948505885218 4.7565658205239725e-07 -0.09262594321329176 +1.0739 0.6939528721626684 0.6939523866456746 4.837329135171098e-07 -0.09262810074287599 +1.074 0.6939567630036482 0.6939562662069758 4.916903030005582e-07 -0.09263025766535432 +1.0741 0.6939606528121648 0.6939601445706958 4.995270103391736e-07 -0.09263241398088348 +1.0742 0.693964541587228 0.6939640217384259 5.072413225004624e-07 -0.09263456968962006 +1.0743 0.6939684293278301 0.6939678977117759 5.148315541103621e-07 -0.0926367247917207 +1.0744 0.6939723160329455 0.6939717724923731 5.22296047730797e-07 -0.09263887928734207 +1.0745 0.6939762017015317 0.6939756460818614 5.296331742482563e-07 -0.09264103317664073 +1.0746000000000002 0.6939800863325292 0.6939795184819015 5.368413332484945e-07 -0.0926431864597732 +1.0747 0.6939839699248613 0.6939833896941712 5.439189533912314e-07 -0.09264533913689597 +1.0748 0.693987852477436 0.6939872597203638 5.508644926738304e-07 -0.09264749120816555 +1.0749000000000002 0.693991733989144 0.6939911285621889 5.576764387643651e-07 -0.09264964267373835 +1.075 0.6939956144588615 0.6939949962213716 5.643533094734643e-07 -0.09265179353377083 +1.0751000000000002 0.6939994938854487 0.693998862699652 5.708936529069675e-07 -0.09265394378841935 +1.0752000000000002 0.6940033722677508 0.6940027279987855 5.772960479100142e-07 -0.09265609343784022 +1.0753 0.6940072496045984 0.6940065921205415 5.835591042613331e-07 -0.09265824248218979 +1.0754000000000001 0.6940111258948076 0.6940104550667044 5.896814630618197e-07 -0.09266039092162437 +1.0755 0.6940150011371804 0.6940143168390721 5.956617970676037e-07 -0.09266253875630018 +1.0756000000000001 0.6940188753305054 0.694018177439456 6.014988108149488e-07 -0.09266468598637345 +1.0757 0.6940227484735574 0.694022036869681 6.071912409810754e-07 -0.09266683261200037 +1.0757999999999999 0.6940266205650982 0.6940258951315847 6.127378568282493e-07 -0.09266897863333709 +1.0759 0.6940304916038773 0.6940297522270176 6.181374602315381e-07 -0.09267112405053972 +1.076 0.6940343615886309 0.6940336081578418 6.233888859841219e-07 -0.09267326886376431 +1.0761 0.6940382305180843 0.6940374629259322 6.284910021026047e-07 -0.09267541307316701 +1.0762 0.6940420983909508 0.6940413165331742 6.334427101462037e-07 -0.09267755667890379 +1.0763 0.6940459652059321 0.6940451689814651 6.382429453138938e-07 -0.0926796996811307 +1.0764 0.6940498309617193 0.6940490202727125 6.428906766942077e-07 -0.09268184208000367 +1.0765 0.6940536956569926 0.6940528704088349 6.473849075844251e-07 -0.09268398387567862 +1.0766000000000002 0.6940575592904221 0.6940567193917604 6.517246756015949e-07 -0.09268612506831142 +1.0767 0.6940614218606682 0.6940605672234271 6.559090529600908e-07 -0.09268826565805798 +1.0768 0.6940652833663817 0.6940644139057823 6.599371465826342e-07 -0.09269040564507407 +1.0769000000000002 0.6940691438062043 0.6940682594407828 6.63808098405605e-07 -0.09269254502951559 +1.077 0.694073003178769 0.6940721038303932 6.675210854484304e-07 -0.09269468381153823 +1.0771000000000002 0.6940768614827001 0.6940759470765869 6.710753201188968e-07 -0.09269682199129775 +1.0772 0.6940807187166146 0.6940797891813448 6.744700501992718e-07 -0.09269895956894991 +1.0773 0.6940845748791212 0.6940836301466559 6.777045591793707e-07 -0.09270109654465032 +1.0774000000000001 0.6940884299688217 0.6940874699745152 6.807781663814572e-07 -0.09270323291855465 +1.0775 0.694092283984311 0.6940913086669256 6.836902270435097e-07 -0.09270536869081848 +1.0776000000000001 0.6940961369241772 0.6940951462258957 6.864401324302438e-07 -0.09270750386159743 +1.0777 0.6940999887870025 0.6940989826534403 6.890273100274014e-07 -0.09270963843104697 +1.0777999999999999 0.6941038395713637 0.6941028179515798 6.914512236805281e-07 -0.09271177239932273 +1.0779 0.6941076892758319 0.6941066521223394 6.937113735672185e-07 -0.09271390576658009 +1.078 0.6941115378989732 0.6941104851677493 6.958072964746709e-07 -0.0927160385329745 +1.0781 0.6941153854393494 0.6941143170898447 6.97738565813566e-07 -0.09271817069866145 +1.0782 0.6941192318955177 0.6941181478906642 6.995047916735775e-07 -0.09272030226379624 +1.0783 0.6941230772660322 0.6941219775722501 7.011056210176614e-07 -0.0927224332285343 +1.0784 0.694126921549443 0.6941258061366482 7.025407375571557e-07 -0.09272456359303091 +1.0785 0.6941307647442974 0.6941296335859072 7.038098620293365e-07 -0.09272669335744134 +1.0786000000000002 0.6941346068491396 0.6941334599220779 7.049127520863951e-07 -0.09272882252192087 +1.0787 0.6941384478625126 0.6941372851472134 7.058492024342167e-07 -0.09273095108662469 +1.0788 0.6941422877829567 0.6941411092633689 7.066190448462573e-07 -0.09273307905170802 +1.0789000000000002 0.6941461266090113 0.6941449322726005 7.072221482051777e-07 -0.09273520641732608 +1.079 0.6941499643392144 0.6941487541769653 7.076584185167212e-07 -0.09273733318363392 +1.0791000000000002 0.6941538009721031 0.6941525749785207 7.079277988264465e-07 -0.09273945935078667 +1.0792 0.6941576365062146 0.6941563946793246 7.080302693723839e-07 -0.09274158491893937 +1.0793 0.6941614709400861 0.6941602132814344 7.079658475572792e-07 -0.09274370988824705 +1.0794000000000001 0.6941653042722555 0.694164030786907 7.07734587823694e-07 -0.09274583425886472 +1.0795 0.6941691365012613 0.6941678471977984 7.073365817789057e-07 -0.09274795803094736 +1.0796000000000001 0.6941729676256438 0.6941716625161628 7.067719580422516e-07 -0.09275008120464992 +1.0797 0.6941767976439439 0.6941754767440529 7.060408822867625e-07 -0.09275220378012726 +1.0797999999999999 0.6941806265547058 0.6941792898835187 7.051435571836517e-07 -0.09275432575753423 +1.0799 0.6941844543564752 0.6941831019366083 7.040802223051701e-07 -0.09275644713702569 +1.08 0.6941882810478016 0.6941869129053663 7.028511541246063e-07 -0.09275856791875646 +1.0801 0.694192106627237 0.694190722791834 7.014566659330201e-07 -0.09276068810288132 +1.0802 0.6941959310933372 0.6941945315980497 6.99897107672709e-07 -0.09276280768955505 +1.0803 0.6941997544446622 0.6941983393260462 6.981728660204745e-07 -0.0927649266789323 +1.0804 0.6942035766797758 0.6942021459778529 6.962843641239447e-07 -0.09276704507116779 +1.0805 0.6942073977972476 0.6942059515554935 6.94232061601574e-07 -0.09276916286641612 +1.0806000000000002 0.6942112177956514 0.6942097560609867 6.92016454362232e-07 -0.0927712800648319 +1.0807 0.6942150366735671 0.6942135594963457 6.896380745913255e-07 -0.09277339666656975 +1.0808 0.6942188544295805 0.6942173618635774 6.870974905148763e-07 -0.09277551267178426 +1.0809000000000002 0.6942226710622834 0.6942211631646826 6.843953063162544e-07 -0.0927776280806299 +1.081 0.6942264865702743 0.6942249634016548 6.815321620251558e-07 -0.09277974289326113 +1.0811000000000002 0.694230300952159 0.6942287625764807 6.785087332955575e-07 -0.09278185710983243 +1.0812 0.6942341142065509 0.694232560691139 6.753257313085737e-07 -0.09278397073049825 +1.0813 0.6942379263320708 0.694236357747601 6.71983902578166e-07 -0.09278608375541299 +1.0814000000000001 0.6942417373273476 0.6942401537478289 6.68484028756855e-07 -0.0927881961847309 +1.0815 0.6942455471910192 0.694243948693777 6.648269264830642e-07 -0.0927903080186064 +1.0816000000000001 0.6942493559217322 0.6942477425873901 6.610134471868312e-07 -0.09279241925719373 +1.0817 0.6942531635181421 0.6942515354306038 6.570444769232742e-07 -0.09279452990064717 +1.0817999999999999 0.6942569699789148 0.6942553272253442 6.529209360672805e-07 -0.09279663994912096 +1.0819 0.6942607753027259 0.6942591179735262 6.486437792163624e-07 -0.09279874940276932 +1.082 0.6942645794882611 0.6942629076770557 6.442139949686121e-07 -0.0928008582617464 +1.0821 0.6942683825342171 0.6942666963378261 6.396326055480017e-07 -0.09280296652620632 +1.0822 0.6942721844393014 0.6942704839577214 6.349006667488721e-07 -0.09280507419630324 +1.0823 0.694275985202233 0.6942742705386125 6.30019267602866e-07 -0.09280718127219113 +1.0824 0.694279784821743 0.6942780560823588 6.249895301846387e-07 -0.09280928775402408 +1.0825 0.6942835832965741 0.6942818405908078 6.198126092510359e-07 -0.09281139364195608 +1.0826000000000002 0.6942873806254819 0.6942856240657946 6.144896920051712e-07 -0.09281349893614112 +1.0827 0.6942911768072346 0.6942894065091407 6.090219979715261e-07 -0.09281560363673316 +1.0828 0.6942949718406136 0.6942931879226546 6.034107785102272e-07 -0.09281770774388609 +1.0829000000000002 0.6942987657244135 0.6942969683081314 5.976573166505128e-07 -0.09281981125775379 +1.083 0.6943025584574432 0.694300747667352 5.917629268548108e-07 -0.09282191417849012 +1.0831000000000002 0.6943063500385251 0.6943045260020828 5.857289545468936e-07 -0.09282401650624883 +1.0832 0.6943101404664964 0.6943083033140761 5.795567759592224e-07 -0.09282611824118372 +1.0833 0.6943139297402094 0.6943120796050694 5.732477977027362e-07 -0.09282821938344861 +1.0834000000000001 0.6943177178585312 0.6943158548767843 5.668034565031732e-07 -0.09283031993319717 +1.0835 0.6943215048203439 0.6943196291309277 5.602252189235157e-07 -0.09283241989058309 +1.0836000000000001 0.6943252906245461 0.6943234023691899 5.535145809337783e-07 -0.09283451925576004 +1.0837 0.6943290752700515 0.6943271745932451 5.466730676889631e-07 -0.0928366180288816 +1.0837999999999999 0.6943328587557908 0.6943309458047516 5.397022330988488e-07 -0.09283871621010138 +1.0839 0.694336641080711 0.6943347160053506 5.326036594394123e-07 -0.09284081379957293 +1.084 0.6943404222437766 0.6943384851966663 5.253789570613954e-07 -0.09284291079744982 +1.0841 0.6943442022439685 0.6943422533803052 5.180297640433595e-07 -0.09284500720388549 +1.0842 0.6943479810802857 0.6943460205578567 5.105577457475974e-07 -0.09284710301903343 +1.0843 0.6943517587517447 0.6943497867308919 5.029645945842098e-07 -0.09284919824304705 +1.0844 0.69435553525738 0.6943535519009638 4.952520294004836e-07 -0.09285129287607975 +1.0845 0.6943593105962448 0.6943573160696073 4.874217952727244e-07 -0.09285338691828493 +1.0846000000000002 0.6943630847674106 0.6943610792383377 4.794756630899233e-07 -0.0928554803698159 +1.0847 0.6943668577699679 0.6943648414086521 4.714154290680339e-07 -0.09285757323082598 +1.0848 0.6943706296030261 0.6943686025820277 4.632429144307837e-07 -0.09285966550146836 +1.0849000000000002 0.6943744002657145 0.6943723627599228 4.549599650210956e-07 -0.09286175718189639 +1.085 0.6943781697571819 0.6943761219437753 4.465684507737322e-07 -0.09286384827226324 +1.0851000000000002 0.6943819380765968 0.6943798801350032 4.380702652989621e-07 -0.09286593877272205 +1.0852 0.6943857052231476 0.6943836373350045 4.294673255911263e-07 -0.09286802868342597 +1.0853 0.6943894711960439 0.6943873935451562 4.207615715637325e-07 -0.0928701180045281 +1.0854000000000001 0.6943932359945151 0.6943911487668151 4.1195496542495436e-07 -0.09287220673618156 +1.0855 0.6943969996178123 0.6943949030013166 4.030494914833427e-07 -0.09287429487853935 +1.0856000000000001 0.694400762065207 0.6943986562499747 3.940471555441416e-07 -0.09287638243175451 +1.0857 0.6944045233359923 0.6944024085140825 3.8494998456928275e-07 -0.09287846939598005 +1.0857999999999999 0.6944082834294829 0.6944061597949109 3.7576002604594594e-07 -0.09288055577136885 +1.0859 0.6944120423450151 0.6944099100937092 3.664793477575756e-07 -0.09288264155807385 +1.086 0.6944158000819471 0.6944136594117045 3.571100371316249e-07 -0.09288472675624798 +1.0861 0.6944195566396596 0.6944174077501019 3.4765420085791643e-07 -0.09288681136604407 +1.0862 0.6944233120175554 0.6944211551100834 3.381139644098585e-07 -0.09288889538761495 +1.0863 0.6944270662150597 0.6944249014928088 3.2849147151708946e-07 -0.09289097882111336 +1.0864 0.6944308192316206 0.6944286468994147 3.187888837768993e-07 -0.09289306166669212 +1.0865 0.6944345710667098 0.6944323913310154 3.0900838007830167e-07 -0.09289514392450399 +1.0866000000000002 0.6944383217198207 0.6944361347887006 2.99152156199578e-07 -0.09289722559470154 +1.0867 0.6944420711904706 0.6944398772735378 2.892224241629604e-07 -0.09289930667743751 +1.0868 0.694445819478201 0.6944436187865705 2.792214119709535e-07 -0.09290138717286453 +1.0869000000000002 0.6944495665825761 0.6944473593288183 2.691513628430564e-07 -0.0929034670811352 +1.087 0.694453312503184 0.6944510989012773 2.5901453497984006e-07 -0.09290554640240208 +1.0871000000000002 0.6944570572396369 0.6944548375049189 2.4881320083436353e-07 -0.09290762513681768 +1.0872 0.6944608007915711 0.6944585751406911 2.3854964670277923e-07 -0.09290970328453454 +1.0873 0.6944645431586469 0.6944623118095168 2.2822617222473252e-07 -0.09291178084570512 +1.0874000000000001 0.6944682843405491 0.694466047512295 2.1784508985600581e-07 -0.09291385782048184 +1.0875 0.6944720243369867 0.6944697822498997 2.0740872432034596e-07 -0.09291593420901709 +1.0876000000000001 0.6944757631476937 0.694473516023181 1.9691941209598607e-07 -0.0929180100114633 +1.0877000000000001 0.6944795007724281 0.6944772488329629 1.8637950096461742e-07 -0.09292008522797277 +1.0877999999999999 0.694483237210974 0.6944809806800454 1.7579134935566398e-07 -0.09292215985869788 +1.0879 0.6944869724631391 0.6944847115652029 1.6515732593341825e-07 -0.09292423390379081 +1.088 0.6944907065287564 0.6944884414891852 1.5447980901764358e-07 -0.0929263073634039 +1.0881 0.6944944394076846 0.6944921704527163 1.437611860527488e-07 -0.09292838023768929 +1.0882 0.6944981710998075 0.6944958984564948 1.330038531047184e-07 -0.09293045252679923 +1.0883 0.6945019016050336 0.6944996255011946 1.2221021426783718e-07 -0.0929325242308858 +1.0884 0.6945056309232971 0.6945033515874632 1.1138268119978423e-07 -0.09293459535010117 +1.0885 0.6945093590545579 0.6945070767159229 1.0052367250060201e-07 -0.09293666588459737 +1.0886000000000002 0.6945130859988015 0.6945108008871708 8.963561326513769e-08 -0.09293873583452658 +1.0887 0.6945168117560383 0.6945145241017772 7.872093445160377e-08 -0.09294080520004071 +1.0888 0.694520536326305 0.6945182463602878 6.77820724218764e-08 -0.09294287398129181 +1.0889000000000002 0.6945242597096635 0.6945219676632215 5.682146831526014e-08 -0.09294494217843181 +1.089 0.6945279819062019 0.694525688011072 4.584156757664326e-08 -0.09294700979161263 +1.0891000000000002 0.6945317029160338 0.6945294074043065 3.484481936842643e-08 -0.09294907682098619 +1.0892 0.6945354227392988 0.6945331258433667 2.3833676032758433e-08 -0.09295114326670434 +1.0893 0.6945391413761621 0.6945368433286683 1.2810592558108735e-08 -0.09295320912891894 +1.0894000000000001 0.6945428588268148 0.6945405598606009 1.7780260076760701e-09 -0.09295527440778176 +1.0895 0.694546575091474 0.694544275439528 -9.261564996691785e-09 -0.09295733910344454 +1.0896000000000001 0.6945502901703828 0.6945479900657874 -2.0305720852594605e-08 -0.09295940321605908 +1.0897000000000001 0.6945540040638098 0.6945517037396902 -3.1351981510940874e-08 -0.09296146674577709 +1.0897999999999999 0.69455771677205 0.6945554164615222 -4.239788701794044e-08 -0.09296352969275017 +1.0899 0.694561428295424 0.6945591282315428 -5.34409780747697e-08 -0.09296559205713004 +1.09 0.694565138634278 0.6945628390499854 -6.447879658021474e-08 -0.09296765383906824 +1.0901 0.6945688477889846 0.6945665489170578 -7.550888617537457e-08 -0.09296971503871644 +1.0902 0.6945725557599416 0.6945702578329411 -8.652879279497788e-08 -0.0929717756562261 +1.0903 0.6945762625475735 0.6945739657977914 -9.753606521317043e-08 -0.0929738356917488 +1.0904 0.6945799681523296 0.694577672811738 -1.0852825558377299e-07 -0.09297589514543596 +1.0905 0.6945836725746856 0.6945813788748845 -1.1950291998845397e-07 -0.09297795401743905 +1.0906000000000002 0.6945873758151423 0.6945850839873092 -1.304576189783968e-07 -0.09298001230790948 +1.0907 0.6945910778742268 0.6945887881490647 -1.4138991811032953e-07 -0.09298207001699868 +1.0908 0.6945947787524911 0.6945924913601768 -1.5229738851291197e-07 -0.09298412714485793 +1.0909 0.6945984784505134 0.6945961936206468 -1.6317760740194864e-07 -0.09298618369163864 +1.091 0.6946021769688966 0.6945998949304502 -1.7402815861988774e-07 -0.09298823965749203 +1.0911000000000002 0.6946058743082693 0.6946035952895366 -1.8484663317011596e-07 -0.09299029504256942 +1.0912 0.6946095704692856 0.6946072946978306 -1.9563062977900891e-07 -0.09299234984702201 +1.0913 0.6946132654526245 0.6946109931552313 -2.063777553885926e-07 -0.09299440407100096 +1.0914000000000001 0.6946169592589901 0.6946146906616125 -2.170856257324716e-07 -0.09299645771465748 +1.0915 0.6946206518891114 0.694618387216823 -2.2775186581808216e-07 -0.0929985107781427 +1.0916000000000001 0.6946243433437427 0.6946220828206864 -2.383741104818038e-07 -0.09300056326160766 +1.0917000000000001 0.6946280336236624 0.6946257774730016 -2.4895000492325403e-07 -0.09300261516520347 +1.0917999999999999 0.6946317227296744 0.6946294711735426 -2.594772051979499e-07 -0.09300466648908118 +1.0919 0.6946354106626067 0.6946331639220589 -2.699533787550723e-07 -0.09300671723339181 +1.092 0.6946390974233119 0.6946368557182752 -2.8037620495788285e-07 -0.09300876739828633 +1.0921 0.6946427830126665 0.6946405465618914 -2.9074337556250773e-07 -0.09301081698391561 +1.0922 0.6946464674315713 0.6946442364525842 -3.010525952973353e-07 -0.09301286599043064 +1.0923 0.6946501506809513 0.6946479253900051 -3.113015823244525e-07 -0.09301491441798225 +1.0924 0.6946538327617555 0.6946516133737823 -3.2148806870802016e-07 -0.09301696226672136 +1.0925 0.6946575136749562 0.6946553004035192 -3.3160980103530413e-07 -0.09301900953679866 +1.0926000000000002 0.6946611934215496 0.6946589864787966 -3.4166454077055874e-07 -0.09302105622836503 +1.0927 0.6946648720025551 0.6946626715991713 -3.516500648864662e-07 -0.09302310234157114 +1.0928 0.6946685494190155 0.6946663557641767 -3.615641662457758e-07 -0.09302514787656779 +1.0929 0.6946722256719959 0.6946700389733229 -3.7140465410784307e-07 -0.09302719283350563 +1.093 0.6946759007625856 0.6946737212260973 -3.8116935471149693e-07 -0.09302923721253525 +1.0931000000000002 0.6946795746918957 0.6946774025219644 -3.9085611164974e-07 -0.09303128101380741 +1.0932 0.69468324746106 0.6946810828603658 -4.0046278638322663e-07 -0.09303332423747258 +1.0933 0.6946869190712346 0.6946847622407208 -4.099872586565967e-07 -0.0930353668836814 +1.0934000000000001 0.6946905895235977 0.6946884406624269 -4.194274270882814e-07 -0.09303740895258433 +1.0935 0.6946942588193494 0.6946921181248588 -4.287812095382648e-07 -0.09303945044433191 +1.0936000000000001 0.6946979269597113 0.6946957946273699 -4.3804654361462303e-07 -0.09304149135907461 +1.0937000000000001 0.6947015939459271 0.6946994701692915 -4.4722138706210224e-07 -0.0930435316969628 +1.0937999999999999 0.6947052597792611 0.694703144749934 -4.5630371833110805e-07 -0.09304557145814692 +1.0939 0.6947089244609992 0.6947068183685865 -4.6529153687607794e-07 -0.09304761064277739 +1.094 0.6947125879924476 0.6947104910245168 -4.741828636967149e-07 -0.09304964925100447 +1.0941 0.6947162503749335 0.6947141627169726 -4.829757417890157e-07 -0.09305168728297852 +1.0942 0.694719911609804 0.6947178334451803 -4.916682364991543e-07 -0.09305372473884975 +1.0943 0.6947235716984266 0.6947215032083467 -5.002584360022655e-07 -0.09305576161876843 +1.0944 0.6947272306421888 0.6947251720056586 -5.087444516771455e-07 -0.09305779792288478 +1.0945 0.6947308884424976 0.6947288398362828 -5.171244185780965e-07 -0.09305983365134898 +1.0946000000000002 0.6947345451007793 0.6947325066993663 -5.253964958373825e-07 -0.09306186880431118 +1.0947 0.6947382006184792 0.6947361725940375 -5.335588670121738e-07 -0.09306390338192147 +1.0948 0.6947418549970616 0.6947398375194054 -5.416097405702702e-07 -0.09306593738432994 +1.0949 0.6947455082380096 0.6947435014745607 -5.495473501399006e-07 -0.0930679708116867 +1.095 0.6947491603428243 0.6947471644585752 -5.573699551064681e-07 -0.09307000366414171 +1.0951000000000002 0.6947528113130244 0.6947508264705026 -5.650758409109224e-07 -0.0930720359418449 +1.0952 0.6947564611501469 0.694754487509379 -5.726633192648656e-07 -0.09307406764494632 +1.0953 0.6947601098557467 0.6947581475742228 -5.801307287472968e-07 -0.09307609877359585 +1.0954000000000002 0.6947637574313947 0.6947618066640349 -5.874764350405348e-07 -0.0930781293279434 +1.0955 0.69476740387868 0.6947654647777993 -5.946988313187962e-07 -0.09308015930813882 +1.0956000000000001 0.6947710491992074 0.6947691219144834 -6.017963386784064e-07 -0.09308218871433195 +1.0957000000000001 0.6947746933945979 0.6947727780730377 -6.08767406276578e-07 -0.09308421754667252 +1.0957999999999999 0.6947783364664892 0.6947764332523971 -6.15610511942033e-07 -0.09308624580531039 +1.0959 0.6947819784165343 0.6947800874514806 -6.223241622582698e-07 -0.09308827349039524 +1.096 0.6947856192464017 0.6947837406691912 -6.289068930631636e-07 -0.09309030060207678 +1.0961 0.694789258957775 0.6947873929044175 -6.353572697542775e-07 -0.0930923271405047 +1.0962 0.6947928975523522 0.6947910441560323 -6.416738874415184e-07 -0.09309435310582863 +1.0963 0.6947965350318458 0.6947946944228944 -6.478553714883706e-07 -0.09309637849819812 +1.0964 0.6948001713979831 0.6947983437038485 -6.539003775396512e-07 -0.09309840331776284 +1.0965 0.6948038066525045 0.6948019919977247 -6.598075921182556e-07 -0.09310042756467224 +1.0966000000000002 0.694807440797164 0.6948056393033402 -6.655757326529121e-07 -0.09310245123907591 +1.0967 0.694811073833729 0.6948092856194983 -6.712035479500278e-07 -0.09310447434112329 +1.0968 0.6948147057639792 0.6948129309449899 -6.766898182769543e-07 -0.09310649687096381 +1.0969 0.6948183365897074 0.6948165752785931 -6.82033355778322e-07 -0.09310851882874693 +1.097 0.6948219663127184 0.6948202186190733 -6.872330046980846e-07 -0.09311054021462206 +1.0971000000000002 0.6948255949348282 0.6948238609651847 -6.922876415738077e-07 -0.09311256102873845 +1.0972 0.6948292224578649 0.6948275023156696 -6.971961755697365e-07 -0.0931145812712455 +1.0973 0.694832848883667 0.6948311426692588 -7.019575486294505e-07 -0.09311660094229245 +1.0974000000000002 0.6948364742140847 0.6948347820246726 -7.065707357672979e-07 -0.09311862004202853 +1.0975 0.6948400984509777 0.6948384203806208 -7.11034745276562e-07 -0.09312063857060307 +1.0976000000000001 0.6948437215962167 0.6948420577358028 -7.153486188404834e-07 -0.0931226565281652 +1.0977000000000001 0.6948473436516811 0.6948456940889081 -7.195114318514495e-07 -0.0931246739148641 +1.0977999999999999 0.6948509646192603 0.6948493294386171 -7.235222936469166e-07 -0.09312669073084892 +1.0979 0.6948545845008521 0.6948529637836007 -7.273803475787988e-07 -0.09312870697626868 +1.098 0.6948582032983635 0.6948565971225213 -7.310847712355129e-07 -0.09313072265127252 +1.0981 0.6948618210137092 0.6948602294540327 -7.34634776705656e-07 -0.09313273775600944 +1.0982 0.6948654376488124 0.6948638607767808 -7.380296106751505e-07 -0.09313475229062845 +1.0983 0.6948690532056032 0.6948674910894039 -7.412685545105102e-07 -0.0931367662552785 +1.0984 0.6948726676860193 0.6948711203905332 -7.443509245502744e-07 -0.09313877965010857 +1.0985 0.694876281092005 0.6948747486787928 -7.472760721882743e-07 -0.09314079247526758 +1.0986000000000002 0.694879893425511 0.6948783759528 -7.500433840401666e-07 -0.09314280473090436 +1.0987 0.694883504688494 0.6948820022111661 -7.526522818601666e-07 -0.09314481641716776 +1.0988 0.6948871148829165 0.694885627452497 -7.551022230961602e-07 -0.09314682753420664 +1.0989 0.694890724010746 0.6948892516753928 -7.57392700626025e-07 -0.09314883808216977 +1.099 0.6948943320739553 0.6948928748784483 -7.595232429796761e-07 -0.09315084806120583 +1.0991000000000002 0.6948979390745214 0.6948964970602545 -7.614934145055985e-07 -0.09315285747146361 +1.0992 0.6949015450144254 0.694900118219397 -7.633028153569699e-07 -0.09315486631309179 +1.0993 0.6949051498956524 0.6949037383544585 -7.649510815610494e-07 -0.093156874586239 +1.0994000000000002 0.694908753720191 0.6949073574640177 -7.664378852412224e-07 -0.09315888229105387 +1.0995 0.6949123564900324 0.6949109755466498 -7.677629345614889e-07 -0.093160889427685 +1.0996000000000001 0.6949159582071709 0.6949145926009281 -7.689259738652421e-07 -0.09316289599628094 +1.0997000000000001 0.6949195588736026 0.6949182086254229 -7.699267834809786e-07 -0.09316490199699022 +1.0997999999999999 0.6949231584913258 0.6949218236187027 -7.70765180124755e-07 -0.09316690742996135 +1.0999 0.6949267570623401 0.6949254375793343 -7.714410167336538e-07 -0.09316891229534281 +1.1 0.694930354588646 0.6949290505058835 -7.719541824380283e-07 -0.093170916593283 +1.1001 0.6949339510722452 0.6949326623969149 -7.7230460270028e-07 -0.09317292032393032 +1.1002 0.6949375465151394 0.6949362732509928 -7.72492239328737e-07 -0.09317492348743317 +1.1003 0.6949411409193303 0.6949398830666812 -7.725170903388756e-07 -0.0931769260839398 +1.1004 0.6949447342868195 0.6949434918425449 -7.723791900643429e-07 -0.09317892811359864 +1.1005 0.6949483266196073 0.6949470995771492 -7.720786091153231e-07 -0.09318092957655792 +1.1006000000000002 0.6949519179196927 0.6949507062690601 -7.716154543369047e-07 -0.09318293047296587 +1.1007 0.6949555081890737 0.6949543119168458 -7.709898688784689e-07 -0.09318493080297074 +1.1008 0.6949590974297459 0.694957916519075 -7.70202031985523e-07 -0.09318693056672062 +1.1009 0.6949626856437028 0.6949615200743202 -7.692521590274559e-07 -0.09318892976436376 +1.101 0.6949662728329348 0.6949651225811555 -7.681405014559051e-07 -0.09319092839604819 +1.1011000000000002 0.6949698589994298 0.6949687240381583 -7.66867346735367e-07 -0.09319292646192208 +1.1012 0.6949734441451714 0.6949723244439092 -7.654330182738089e-07 -0.0931949239621334 +1.1013 0.6949770282721404 0.6949759237969926 -7.638378752977681e-07 -0.09319692089683027 +1.1014000000000002 0.6949806113823123 0.694979522095997 -7.620823128523524e-07 -0.09319891726616059 +1.1015 0.6949841934776584 0.6949831193395156 -7.601667616485841e-07 -0.09320091307027237 +1.1016000000000001 0.6949877745601453 0.6949867155261461 -7.580916879801336e-07 -0.09320290830931352 +1.1017000000000001 0.6949913546317337 0.6949903106544917 -7.558575935706635e-07 -0.09320490298343193 +1.1018 0.6949949336943788 0.694993904723161 -7.534650153934175e-07 -0.09320689709277548 +1.1019 0.6949985117500301 0.6949974977307687 -7.509145257544869e-07 -0.09320889063749199 +1.102 0.6950020888006296 0.695001089675936 -7.482067320152552e-07 -0.09321088361772924 +1.1021 0.6950056648481138 0.6950046805572907 -7.453422764119866e-07 -0.0932128760336351 +1.1022 0.6950092398944107 0.6950082703734675 -7.42321835986437e-07 -0.09321486788535717 +1.1023 0.6950128139414413 0.6950118591231085 -7.391461223915652e-07 -0.09321685917304323 +1.1024 0.6950163869911189 0.6950154468048644 -7.358158817805105e-07 -0.093218849896841 +1.1025 0.6950199590453479 0.695019033417393 -7.323318945429147e-07 -0.09322084005689801 +1.1026000000000002 0.6950235301060244 0.6950226189593613 -7.286949751522664e-07 -0.09322282965336197 +1.1027 0.6950271001750352 0.6950262034294451 -7.249059720410012e-07 -0.09322481868638037 +1.1028 0.6950306692542582 0.6950297868263293 -7.209657672535563e-07 -0.09322680715610084 +1.1029 0.6950342373455611 0.6950333691487087 -7.168752764880049e-07 -0.0932287950626709 +1.103 0.6950378044508015 0.6950369503952878 -7.126354486242104e-07 -0.09323078240623794 +1.1031000000000002 0.695041370571827 0.6950405305647811 -7.082472656405603e-07 -0.09323276918694946 +1.1032 0.6950449357104738 0.6950441096559146 -7.037117424057993e-07 -0.09323475540495291 +1.1033 0.6950484998685675 0.6950476876674245 -6.990299263737176e-07 -0.09323674106039564 +1.1034000000000002 0.6950520630479222 0.6950512645980592 -6.942028973333514e-07 -0.09323872615342511 +1.1035 0.6950556252503398 0.6950548404465777 -6.892317672563264e-07 -0.09324071068418859 +1.1036000000000001 0.6950591864776103 0.6950584152117517 -6.841176800193027e-07 -0.09324269465283333 +1.1037000000000001 0.6950627467315109 0.695061988892365 -6.788618110570299e-07 -0.09324467805950658 +1.1038 0.6950663060138066 0.6950655614872145 -6.734653670570356e-07 -0.09324666090435563 +1.1039 0.6950698643262485 0.6950691329951095 -6.679295859318701e-07 -0.09324864318752765 +1.104 0.695073421670575 0.6950727034148731 -6.622557363056281e-07 -0.09325062490916983 +1.1041 0.6950769780485102 0.6950762727453419 -6.564451173196595e-07 -0.09325260606942928 +1.1042 0.6950805334617642 0.6950798409853665 -6.504990582439918e-07 -0.09325458666845315 +1.1043 0.6950840879120329 0.6950834081338118 -6.444189182969184e-07 -0.0932565667063885 +1.1044 0.6950876414009971 0.6950869741895569 -6.382060862286654e-07 -0.09325854618338236 +1.1045 0.6950911939303228 0.6950905391514968 -6.318619801409797e-07 -0.09326052509958177 +1.1046 0.6950947455016606 0.6950941030185407 -6.253880470014073e-07 -0.0932625034551337 +1.1047 0.6950982961166452 0.695097665789614 -6.187857623934923e-07 -0.09326448125018508 +1.1048 0.6951018457768958 0.6951012274636573 -6.120566301975883e-07 -0.09326645848488285 +1.1049 0.6951053944840144 0.6951047880396278 -6.052021822300357e-07 -0.09326843515937379 +1.105 0.695108942239588 0.695108347516499 -5.982239778962173e-07 -0.09327041127380488 +1.1051000000000002 0.6951124890451856 0.6951119058932613 -5.911236038713685e-07 -0.09327238682832291 +1.1052 0.6951160349023597 0.6951154631689217 -5.839026736842445e-07 -0.09327436182307475 +1.1053 0.6951195798126448 0.6951190193425046 -5.765628273007861e-07 -0.09327633625820703 +1.1054000000000002 0.6951231237775584 0.695122574413052 -5.691057308881975e-07 -0.09327831013386656 +1.1055 0.6951266667985989 0.6951261283796234 -5.615330763431015e-07 -0.09328028345019994 +1.1056000000000001 0.6951302088772481 0.6951296812412967 -5.538465809862281e-07 -0.09328225620735392 +1.1057000000000001 0.6951337500149684 0.6951332329971683 -5.460479870766921e-07 -0.09328422840547512 +1.1058 0.6951372902132036 0.6951367836463529 -5.381390614650483e-07 -0.0932862000447102 +1.1059 0.6951408294733782 0.695140333187984 -5.301215952532856e-07 -0.09328817112520559 +1.106 0.695144367796898 0.6951438816212139 -5.219974032952268e-07 -0.09329014164710785 +1.1061 0.6951479051851492 0.6951474289452153 -5.137683238010116e-07 -0.09329211161056358 +1.1062 0.6951514416394979 0.69515097515918 -5.054362179554572e-07 -0.09329408101571925 +1.1063 0.6951549771612908 0.6951545202623188 -4.970029694878475e-07 -0.09329604986272125 +1.1064 0.6951585117518541 0.695158064253864 -4.884704842555987e-07 -0.09329801815171603 +1.1065 0.6951620454124932 0.6951616071330669 -4.798406897793539e-07 -0.09329998588284993 +1.1066 0.6951655781444934 0.6951651488992001 -4.7111553483358826e-07 -0.09330195305626933 +1.1067 0.6951691099491193 0.6951686895515568 -4.6229698903721417e-07 -0.0933039196721206 +1.1068 0.6951726408276135 0.695172229089451 -4.533870423123476e-07 -0.09330588573054995 +1.1069 0.6951761707811983 0.6951757675122179 -4.4438770461369126e-07 -0.09330785123170365 +1.107 0.695179699811074 0.6951793048192141 -4.35301005241584e-07 -0.09330981617572796 +1.1071000000000002 0.6951832279184187 0.6951828410098178 -4.261289925922007e-07 -0.09331178056276901 +1.1072 0.6951867551043895 0.6951863760834291 -4.168737335330519e-07 -0.09331374439297302 +1.1073 0.6951902813701212 0.6951899100394697 -4.075373130421611e-07 -0.09331570766648606 +1.1074000000000002 0.6951938067167259 0.6951934428773839 -3.981218337570369e-07 -0.0933176703834543 +1.1075 0.6951973311452939 0.695196974596638 -3.886294154265002e-07 -0.09331963254402377 +1.1076000000000001 0.6952008546568922 0.6952005051967205 -3.790621944457784e-07 -0.0933215941483405 +1.1077000000000001 0.6952043772525653 0.6952040346771435 -3.694223233846605e-07 -0.09332355519655053 +1.1078 0.6952078989333347 0.6952075630374415 -3.597119705642249e-07 -0.0933255156887998 +1.1079 0.6952114197001986 0.6952110902771713 -3.4993331950172735e-07 -0.09332747562523425 +1.108 0.695214939554132 0.6952146163959136 -3.400885684040622e-07 -0.09332943500599973 +1.1081 0.6952184584960868 0.6952181413932729 -3.3017992970285626e-07 -0.09333139383124223 +1.1082 0.6952219765269911 0.6952216652688759 -3.202096296103796e-07 -0.09333335210110758 +1.1083 0.6952254936477493 0.6952251880223734 -3.101799075158618e-07 -0.09333530981574155 +1.1084 0.6952290098592417 0.6952287096534406 -3.0009301556915835e-07 -0.09333726697528996 +1.1085 0.6952325251623246 0.6952322301617757 -2.8995121816727254e-07 -0.09333922357989854 +1.1086 0.6952360395578303 0.6952357495471011 -2.797567913680188e-07 -0.093341179629713 +1.1087 0.6952395530465674 0.6952392678091635 -2.695120224667502e-07 -0.09334313512487906 +1.1088 0.6952430656293194 0.6952427849477336 -2.592192094343082e-07 -0.09334509006554237 +1.1089 0.6952465773068457 0.6952463009626063 -2.4888066043129986e-07 -0.09334704445184855 +1.109 0.6952500880798811 0.6952498158536012 -2.384986932633948e-07 -0.09334899828394316 +1.1091000000000002 0.6952535979491359 0.6952533296205627 -2.2807563489213312e-07 -0.09335095156197186 +1.1092 0.6952571069152951 0.6952568422633592 -2.176138208902223e-07 -0.09335290428608008 +1.1093 0.6952606149790195 0.6952603537818837 -2.0711559492458953e-07 -0.09335485645641338 +1.1094000000000002 0.6952641221409446 0.6952638641760546 -1.965833082290258e-07 -0.09335680807311716 +1.1095 0.6952676284016814 0.6952673734458148 -1.8601931909417724e-07 -0.09335875913633696 +1.1096000000000001 0.6952711337618152 0.695270881591132 -1.7542599232978073e-07 -0.09336070964621807 +1.1097000000000001 0.6952746382219068 0.6952743886119994 -1.6480569871302198e-07 -0.09336265960290599 +1.1098 0.6952781417824915 0.6952778945084348 -1.5416081447505725e-07 -0.09336460900654597 +1.1099 0.6952816444440795 0.695281399280481 -1.4349372080314782e-07 -0.09336655785728343 +1.11 0.6952851462071552 0.695284902928206 -1.328068032647317e-07 -0.09336850615526349 +1.1101 0.695288647072179 0.6952884054517032 -1.2210245126792474e-07 -0.09337045390063155 +1.1102 0.6952921470395844 0.6952919068510912 -1.1138305756538958e-07 -0.09337240109353274 +1.1103 0.6952956461097806 0.6952954071265136 -1.0065101770269369e-07 -0.0933743477341123 +1.1104 0.6952991442831509 0.6952989062781395 -8.990872947187145e-08 -0.09337629382251533 +1.1105 0.6953026415600532 0.6953024043061629 -7.915859239100709e-08 -0.09337823935888698 +1.1106 0.6953061379408204 0.6953059012108035 -6.840300715866415e-08 -0.09338018434337234 +1.1107 0.6953096334257597 0.6953093969923064 -5.764437512219278e-08 -0.09338212877611653 +1.1108 0.6953131280151524 0.6953128916509418 -4.6885097737797005e-08 -0.0933840726572645 +1.1109 0.6953166217092552 0.6953163851870048 -3.612757604388355e-08 -0.09338601598696127 +1.111 0.6953201145082991 0.6953198776008164 -2.5374210116738127e-08 -0.09338795876535187 +1.1111000000000002 0.6953236064124891 0.6953233688927227 -1.4627398537206404e-08 -0.09338990099258117 +1.1112 0.6953270974220054 0.695326859063095 -3.889537856724412e-09 -0.09339184266879408 +1.1113 0.6953305875370028 0.6953303481123295 6.8369779377894235e-09 -0.09339378379413546 +1.1114000000000002 0.695334076757611 0.6953338360408483 1.7549757958500167e-08 -0.09339572436875022 +1.1115 0.6953375650839337 0.695337322849098 2.8246414944879672e-08 -0.09339766439278309 +1.1116000000000001 0.6953410525160497 0.6953408085375508 3.8924565810144474e-08 -0.09339960386637891 +1.1117000000000001 0.6953445390540132 0.6953442931067035 4.958183214345824e-08 -0.09340154278968238 +1.1118 0.6953480246978523 0.6953477765570784 6.021584077545161e-08 -0.09340348116283828 +1.1119 0.6953515094475707 0.6953512588892219 7.082422428389412e-08 -0.09340541898599121 +1.112 0.6953549933031468 0.6953547401037066 8.140462151064176e-08 -0.09340735625928588 +1.1121 0.6953584762645342 0.6953582202011289 9.195467812542213e-08 -0.09340929298286696 +1.1122 0.6953619583316613 0.6953616991821101 1.02472047111557e-07 -0.09341122915687897 +1.1122999999999998 0.6953654395044321 0.6953651770472962 1.1295438931066548e-07 -0.09341316478146641 +1.1124 0.6953689197827257 0.6953686537973579 1.2339937394134637e-07 -0.09341509985677396 +1.1125 0.6953723991663969 0.69537212943299 1.3380467909704374e-07 -0.09341703438294596 +1.1126 0.6953758776552756 0.6953756039549124 1.4416799227687238e-07 -0.09341896836012697 +1.1127 0.6953793552491676 0.6953790773638685 1.5448701091991257e-07 -0.09342090178846142 +1.1128 0.6953828319478543 0.6953825496606262 1.6475944288052435e-07 -0.0934228346680937 +1.1129 0.6953863077510931 0.6953860208459774 1.74983006952234e-07 -0.0934247669991682 +1.113 0.6953897826586171 0.6953894909207378 1.8515543341243723e-07 -0.09342669878182924 +1.1131000000000002 0.6953932566701355 0.6953929598857471 1.952744644283244e-07 -0.09342863001622115 +1.1132 0.6953967297853341 0.6953964277418683 2.0533785465015608e-07 -0.09343056070248817 +1.1133 0.6954002020038745 0.6953998944899882 2.1534337170392437e-07 -0.0934324908407746 +1.1134000000000002 0.695403673325395 0.6954033601310172 2.2528879661115608e-07 -0.09343442043122462 +1.1135 0.6954071437495108 0.6954068246658884 2.3517192441341317e-07 -0.09343634947398244 +1.1136000000000001 0.6954106132758135 0.6954102880955582 2.449905644741346e-07 -0.09343827796919216 +1.1137000000000001 0.695414081903872 0.6954137504210058 2.547425411655868e-07 -0.09344020591699795 +1.1138 0.695417549633232 0.6954172116432337 2.6442569418111406e-07 -0.09344213331754388 +1.1139000000000001 0.6954210164634166 0.6954206717632663 2.740378791665776e-07 -0.093444060170974 +1.114 0.6954244823939264 0.6954241307821507 2.83576968039545e-07 -0.09344598647743235 +1.1141 0.6954279474242399 0.6954275887009567 2.9304084957909593e-07 -0.09344791223706296 +1.1142 0.6954314115538126 0.6954310455207748 3.0242742985603366e-07 -0.09344983745000973 +1.1142999999999998 0.6954348747820789 0.695434501242719 3.11734632697791e-07 -0.09345176211641665 +1.1144 0.6954383371084507 0.695437955867924 3.209604001255806e-07 -0.09345368623642758 +1.1145 0.6954417985323189 0.6954414093975463 3.301026928401174e-07 -0.09345560981018643 +1.1146 0.6954452590530525 0.6954448618327636 3.3915949066570805e-07 -0.09345753283783705 +1.1147 0.6954487186699998 0.6954483131747745 3.481287929388288e-07 -0.09345945531952321 +1.1148 0.6954521773824873 0.6954517634247988 3.570086190909927e-07 -0.09346137725538871 +1.1149 0.6954556351898216 0.6954552125840766 3.6579700894712186e-07 -0.09346329864557727 +1.115 0.6954590920912884 0.6954586606538686 3.744920231973925e-07 -0.09346521949023265 +1.1151000000000002 0.6954625480861528 0.6954621076354557 3.830917438898962e-07 -0.09346713978949849 +1.1152 0.69546600317366 0.6954655535301388 3.915942747637069e-07 -0.09346905954351843 +1.1153 0.6954694573530359 0.6954689983392384 3.999977416860312e-07 -0.09347097875243617 +1.1154000000000002 0.6954729106234856 0.6954724420640948 4.0830029311711424e-07 -0.09347289741639522 +1.1155 0.695476362984196 0.6954758847060668 4.1650010048494e-07 -0.0934748155355392 +1.1156000000000001 0.6954798144343339 0.6954793262665332 4.2459535861544273e-07 -0.09347673311001156 +1.1157000000000001 0.695483264973048 0.695482766746891 4.3258428605169597e-07 -0.09347865013995586 +1.1158 0.6954867145994676 0.6954862061485556 4.4046512550494077e-07 -0.09348056662551554 +1.1159000000000001 0.6954901633127046 0.6954896444729609 4.482361442778582e-07 -0.09348248256683404 +1.116 0.6954936111118519 0.695493081721559 4.558956345768195e-07 -0.09348439796405478 +1.1161 0.6954970579959849 0.695496517895819 4.6344191394209755e-07 -0.09348631281732113 +1.1162 0.6955005039641617 0.695499952997228 4.708733255393005e-07 -0.09348822712677642 +1.1162999999999998 0.6955039490154223 0.69550338702729 4.781882386728498e-07 -0.09349014089256391 +1.1164 0.695507393148791 0.6955068199875263 4.853850488761857e-07 -0.09349205411482697 +1.1165 0.6955108363632742 0.695510251879474 4.924621785640237e-07 -0.0934939667937088 +1.1166 0.6955142786578621 0.695513682704687 4.994180772127654e-07 -0.0934958789293526 +1.1167 0.695517720031529 0.6955171124647358 5.062512217490767e-07 -0.09349779052190157 +1.1168 0.6955211604832334 0.6955205411612055 5.129601168829545e-07 -0.09349970157149884 +1.1169 0.6955246000119182 0.6955239687956976 5.195432953991608e-07 -0.09350161207828761 +1.117 0.6955280386165104 0.6955273953698278 5.259993184764111e-07 -0.09350352204241089 +1.1171000000000002 0.6955314762959228 0.6955308208852273 5.323267760898309e-07 -0.09350543146401175 +1.1172 0.6955349130490533 0.6955342453435421 5.38524287219122e-07 -0.09350734034323324 +1.1173 0.6955383488747857 0.6955376687464315 5.445905002093854e-07 -0.09350924868021836 +1.1174000000000002 0.6955417837719893 0.6955410910955693 5.505240930070432e-07 -0.09351115647511005 +1.1175 0.6955452177395198 0.6955445123926428 5.563237735761728e-07 -0.09351306372805125 +1.1176000000000001 0.6955486507762199 0.6955479326393526 5.619882799540177e-07 -0.09351497043918489 +1.1177000000000001 0.6955520828809185 0.6955513518374119 5.675163807783434e-07 -0.09351687660865382 +1.1178 0.6955555140524327 0.6955547699885472 5.729068753568267e-07 -0.09351878223660089 +1.1179000000000001 0.6955589442895664 0.6955581870944963 5.781585941250222e-07 -0.09352068732316893 +1.118 0.695562373591112 0.6955616031570103 5.83270398632485e-07 -0.09352259186850072 +1.1181 0.6955658019558493 0.6955650181778503 5.882411820701261e-07 -0.09352449587273894 +1.1182 0.6955692293825476 0.69556843215879 5.930698693257241e-07 -0.09352639933602637 +1.1182999999999998 0.6955726558699646 0.6955718451016135 5.977554173031141e-07 -0.09352830225850566 +1.1184 0.6955760814168475 0.6955752570081156 6.022968151303543e-07 -0.09353020464031947 +1.1185 0.695579506021933 0.6955786678801014 6.066930843401375e-07 -0.09353210648161048 +1.1186 0.6955829296839475 0.6955820777193857 6.109432790502023e-07 -0.0935340077825212 +1.1187 0.6955863524016084 0.6955854865277933 6.150464863519112e-07 -0.09353590854319427 +1.1188 0.6955897741736227 0.695588894307158 6.190018263241281e-07 -0.09353780876377214 +1.1189 0.6955931949986893 0.6955923010593222 6.228084522552635e-07 -0.09353970844439737 +1.119 0.695596614875498 0.6955957067861371 6.264655508514405e-07 -0.09354160758521235 +1.1191000000000002 0.6956000338027305 0.6955991114894625 6.299723424585402e-07 -0.0935435061863596 +1.1192 0.6956034517790604 0.6956025151711653 6.3332808113159e-07 -0.09354540424798151 +1.1193 0.6956068688031537 0.6956059178331199 6.365320548290532e-07 -0.0935473017702204 +1.1194000000000002 0.6956102848736696 0.6956093194772083 6.395835856348731e-07 -0.09354919875321867 +1.1195 0.6956136999892599 0.6956127201053187 6.424820298001066e-07 -0.09355109519711861 +1.1196000000000002 0.6956171141485699 0.695616119719346 6.452267778539467e-07 -0.09355299110206246 +1.1197000000000001 0.6956205273502392 0.6956195183211913 6.478172549784222e-07 -0.09355488646819254 +1.1198 0.6956239395929016 0.6956229159127606 6.502529207447205e-07 -0.09355678129565105 +1.1199000000000001 0.6956273508751849 0.6956263124959658 6.525332695156427e-07 -0.09355867558458014 +1.12 0.6956307611957127 0.6956297080727236 6.546578305566264e-07 -0.09356056933512202 +1.1201 0.6956341705531034 0.695633102644955 6.566261679108454e-07 -0.09356246254741879 +1.1202 0.6956375789459708 0.6956364962145856 6.584378806351321e-07 -0.09356435522161252 +1.1202999999999999 0.6956409863729258 0.695639888783544 6.600926029248777e-07 -0.0935662473578453 +1.1204 0.6956443928325746 0.6956432803537631 6.615900041556655e-07 -0.09356813895625915 +1.1205 0.6956477983235214 0.6956466709271787 6.629297887861263e-07 -0.09357003001699613 +1.1206 0.6956512028443662 0.6956500605057284 6.641116966771277e-07 -0.09357192054019808 +1.1207 0.6956546063937077 0.6956534490913533 6.651355029946293e-07 -0.09357381052600705 +1.1208 0.6956580089701421 0.6956568366859959 6.660010181819276e-07 -0.0935756999745649 +1.1209 0.695661410572264 0.6956602232915998 6.667080882372112e-07 -0.09357758888601353 +1.121 0.695664811198667 0.6956636089101107 6.672565944221276e-07 -0.09357947726049479 +1.1211000000000002 0.6956682108479427 0.6956669935434743 6.676464536503612e-07 -0.09358136509815043 +1.1212 0.6956716095186835 0.6956703771936372 6.678776180851775e-07 -0.09358325239912231 +1.1213 0.6956750072094808 0.695673759862546 6.679500754724899e-07 -0.09358513916355216 +1.1214000000000002 0.6956784039189262 0.6956771415521465 6.678638490159594e-07 -0.09358702539158166 +1.1215 0.6956817996456122 0.6956805222643849 6.676189972243396e-07 -0.09358891108335256 +1.1216000000000002 0.6956851943881321 0.6956839020012049 6.672156142445429e-07 -0.09359079623900647 +1.1217000000000001 0.6956885881450801 0.6956872807645498 6.666538294175517e-07 -0.09359268085868501 +1.1218 0.6956919809150528 0.695690658556361 6.659338076253629e-07 -0.09359456494252985 +1.1219000000000001 0.6956953726966486 0.6956940353785772 6.650557488468989e-07 -0.0935964484906825 +1.122 0.6956987634884682 0.6956974112331347 6.640198885465853e-07 -0.09359833150328446 +1.1221 0.695702153289115 0.6957007861219673 6.628264971886288e-07 -0.0936002139804773 +1.1222 0.6957055420971958 0.6957041600470052 6.614758804729393e-07 -0.09360209592240246 +1.1222999999999999 0.6957089299113209 0.6957075330101747 6.599683791685962e-07 -0.09360397732920138 +1.1224 0.6957123167301046 0.6957109050133985 6.583043688918044e-07 -0.0936058582010155 +1.1225 0.6957157025521652 0.6957142760585946 6.56484260300183e-07 -0.0936077385379862 +1.1226 0.6957190873761261 0.6957176461476761 6.545084987319427e-07 -0.09360961834025477 +1.1227 0.6957224712006154 0.6957210152825513 6.523775641503748e-07 -0.09361149760796263 +1.1228 0.6957258540242661 0.6957243834651228 6.500919711716069e-07 -0.09361337634125096 +1.1229 0.6957292358457181 0.6957277506972872 6.47652268773169e-07 -0.09361525454026108 +1.123 0.6957326166636166 0.695731116980935 6.45059040280116e-07 -0.09361713220513418 +1.1231000000000002 0.6957359964766133 0.6957344823179501 6.423129030735941e-07 -0.09361900933601144 +1.1232 0.695739375283367 0.6957378467102096 6.394145087573744e-07 -0.09362088593303404 +1.1233 0.6957427530825435 0.695741210159583 6.363645425888631e-07 -0.09362276199634313 +1.1234000000000002 0.6957461298728163 0.6957445726679324 6.331637236872689e-07 -0.0936246375260798 +1.1235 0.6957495056528669 0.6957479342371116 6.298128045756357e-07 -0.09362651252238513 +1.1236000000000002 0.6957528804213843 0.6957512948689659 6.263125711947204e-07 -0.0936283869854001 +1.1237000000000001 0.6957562541770672 0.6957546545653324 6.226638426670705e-07 -0.09363026091526579 +1.1238 0.6957596269186226 0.6957580133280388 6.188674711027353e-07 -0.09363213431212312 +1.1239000000000001 0.6957629986447669 0.6957613711589032 6.14924341307832e-07 -0.0936340071761131 +1.124 0.6957663693542262 0.6957647280597341 6.108353708261793e-07 -0.09363587950737656 +1.1241 0.6957697390457364 0.6957680840323303 6.066015094119415e-07 -0.09363775130605445 +1.1242 0.6957731077180437 0.6957714390784795 6.02223739099017e-07 -0.09363962257228758 +1.1242999999999999 0.6957764753699056 0.6957747931999587 5.977030737708278e-07 -0.09364149330621681 +1.1244 0.6957798420000898 0.6957781463985342 5.93040559049296e-07 -0.09364336350798289 +1.1245 0.6957832076073759 0.6957814986759605 5.882372719201445e-07 -0.0936452331777266 +1.1246 0.6957865721905545 0.6957848500339805 5.832943205941188e-07 -0.09364710231558868 +1.1247 0.6957899357484292 0.6957882004743243 5.782128443126977e-07 -0.09364897092170979 +1.1248 0.695793298279815 0.695791549998711 5.729940128623712e-07 -0.09365083899623067 +1.1249 0.6957966597835397 0.6957948986088454 5.676390265330067e-07 -0.09365270653929186 +1.125 0.6958000202584443 0.6957982463064201 5.621491157847824e-07 -0.09365457355103401 +1.1251000000000002 0.6958033797033831 0.6958015930931141 5.565255408318537e-07 -0.09365644003159772 +1.1252 0.6958067381172238 0.6958049389705929 5.507695915313304e-07 -0.09365830598112351 +1.1253 0.695810095498848 0.6958082839405075 5.448825869669438e-07 -0.09366017139975191 +1.1254000000000002 0.6958134518471515 0.6958116280044948 5.388658752408793e-07 -0.09366203628762333 +1.1255 0.6958168071610444 0.6958149711641771 5.327208330990763e-07 -0.09366390064487827 +1.1256000000000002 0.6958201614394521 0.695818313421162 5.26448865625917e-07 -0.09366576447165714 +1.1257000000000001 0.6958235146813148 0.6958216547770417 5.20051405938915e-07 -0.09366762776810035 +1.1258 0.6958268668855878 0.6958249952333926 5.135299148556483e-07 -0.09366949053434821 +1.1259000000000001 0.6958302180512429 0.6958283347917757 5.06885880588448e-07 -0.09367135277054112 +1.126 0.6958335681772669 0.6958316734537358 5.001208183003092e-07 -0.0936732144768193 +1.1261 0.6958369172626633 0.6958350112208009 4.93236269966113e-07 -0.093675075653323 +1.1262 0.6958402653064524 0.6958383480944831 4.862338038175151e-07 -0.09367693630019254 +1.1262999999999999 0.6958436123076708 0.6958416840762771 4.791150140653899e-07 -0.09367879641756804 +1.1264 0.6958469582653724 0.6958450191676606 4.7188152052513033e-07 -0.09368065600558977 +1.1265 0.6958503031786283 0.6958483533700939 4.6453496832521424e-07 -0.09368251506439779 +1.1266 0.6958536470465273 0.695851686685019 4.5707702739372635e-07 -0.09368437359413223 +1.1267 0.6958569898681763 0.6958550191138605 4.49509392208558e-07 -0.09368623159493317 +1.1268 0.6958603316426998 0.6958583506580245 4.418337812908679e-07 -0.0936880890669406 +1.1269 0.6958636723692412 0.6958616813188989 4.3405193697609867e-07 -0.09368994601029464 +1.127 0.695867012046962 0.6958650110978525 4.2616562481723186e-07 -0.09369180242513522 +1.1271000000000002 0.6958703506750428 0.6958683399962353 4.181766334321324e-07 -0.0936936583116023 +1.1272 0.6958736882526833 0.695871668015378 4.10086773823537e-07 -0.0936955136698358 +1.1273 0.6958770247791027 0.6958749951565923 4.0189787917088715e-07 -0.09369736849997563 +1.1274000000000002 0.6958803602535393 0.6958783214211692 3.9361180437236243e-07 -0.09369922280216163 +1.1275 0.6958836946752518 0.6958816468103809 3.8523042554527986e-07 -0.09370107657653368 +1.1276000000000002 0.6958870280435181 0.6958849713254786 3.7675563969302717e-07 -0.0937029298232315 +1.1277000000000001 0.6958903603576367 0.6958882949676937 3.681893642332179e-07 -0.09370478254239485 +1.1278 0.6958936916169272 0.695891617738237 3.595335365952357e-07 -0.09370663473416363 +1.1279000000000001 0.6958970218207284 0.6958949396382985 3.5079011372063373e-07 -0.09370848639867735 +1.128 0.695900350968401 0.6958982606690468 3.419610716884347e-07 -0.09371033753607576 +1.1281 0.6959036790593269 0.69590158083163 3.330484052571636e-07 -0.09371218814649854 +1.1282 0.6959070060929083 0.6959049001271747 3.240541273652475e-07 -0.0937140382300853 +1.1282999999999999 0.6959103320685697 0.6959082185567853 3.1498026873549856e-07 -0.0937158877869756 +1.1284 0.6959136569857565 0.6959115361215455 3.0582887739633025e-07 -0.09371773681730906 +1.1285 0.695916980843936 0.6959148528225165 2.9660201816827936e-07 -0.09371958532122508 +1.1286 0.695920303642598 0.695918168660737 2.8730177231012233e-07 -0.09372143329886318 +1.1287 0.6959236253812537 0.6959214836372245 2.7793023694988594e-07 -0.09372328075036285 +1.1288 0.6959269460594374 0.6959247977529737 2.684895246893304e-07 -0.09372512767586359 +1.1289 0.695930265676705 0.6959281110089561 2.5898176300720444e-07 -0.09372697407550473 +1.129 0.6959335842326354 0.6959314234061211 2.494090939331173e-07 -0.09372881994942563 +1.1291000000000002 0.69593690172683 0.6959347349453953 2.397736734716105e-07 -0.09373066529776558 +1.1292 0.6959402181589134 0.6959380456276817 2.300776711233743e-07 -0.09373251012066397 +1.1293 0.6959435335285333 0.695941355453861 2.2032326944115832e-07 -0.0937343544182601 +1.1294000000000002 0.6959468478353602 0.6959446644247902 2.1051266346772124e-07 -0.09373619819069319 +1.1295 0.6959501610790877 0.6959479725413027 2.00648060326436e-07 -0.09373804143810238 +1.1296000000000002 0.6959534732594332 0.6959512798042086 1.9073167864883112e-07 -0.09373988416062691 +1.1297000000000001 0.6959567843761378 0.6959545862142941 1.8076574813397084e-07 -0.09374172635840591 +1.1298 0.6959600944289657 0.6959578917723218 1.7075250903497707e-07 -0.09374356803157852 +1.1299000000000001 0.6959634034177049 0.6959611964790309 1.6069421159697894e-07 -0.09374540918028379 +1.13 0.6959667113421675 0.695964500335136 1.505931156373097e-07 -0.09374724980466084 +1.1301 0.6959700182021898 0.6959678033413279 1.4045148998345636e-07 -0.0937490899048487 +1.1302 0.6959733239976316 0.6959711054982731 1.3027161197345927e-07 -0.09375092948098634 +1.1302999999999999 0.6959766287283765 0.6959744068066143 1.200557669701896e-07 -0.09375276853321272 +1.1304 0.6959799323943332 0.6959777072669692 1.0980624780623782e-07 -0.09375460706166681 +1.1305 0.6959832349954342 0.6959810068799316 9.952535430166054e-08 -0.09375644506648748 +1.1306 0.695986536531636 0.6959843056460708 8.921539276091073e-08 -0.09375828254781361 +1.1307 0.6959898370029202 0.6959876035659315 7.887867539690951e-08 -0.09376011950578408 +1.1308 0.6959931364092923 0.6959909006400338 6.85175198661403e-08 -0.09376195594053767 +1.1309 0.6959964347507823 0.6959941968688732 5.813424873782336e-08 -0.09376379185221317 +1.131 0.6959997320274453 0.6959974922529206 4.773118896135575e-08 -0.09376562724094936 +1.1311000000000002 0.69600302823936 0.6960007867926223 3.7310671345894275e-08 -0.09376746210688493 +1.1312 0.6960063233866307 0.6960040804883993 2.687503005555092e-08 -0.09376929645015857 +1.1313 0.6960096174693858 0.6960073733406487 1.642660205948554e-08 -0.09377113027090894 +1.1314000000000002 0.6960129104877786 0.6960106653497417 5.967726641846471e-09 -0.09377296356927464 +1.1315 0.696016202441987 0.6960139565160255 -4.499255151606263e-09 -0.09377479634539432 +1.1316000000000002 0.6960194933322137 0.6960172468398222 -1.4972001021774928e-08 -0.09377662859940653 +1.1317000000000002 0.6960227831586863 0.6960205363214294 -2.5448167944881056e-08 -0.09377846033144983 +1.1318 0.6960260719216562 0.6960238249611194 -3.592541269223197e-08 -0.09378029154166272 +1.1319000000000001 0.6960293596214006 0.6960271127591395 -4.6401392361317215e-08 -0.09378212223018359 +1.132 0.6960326462582208 0.6960303997157129 -5.6873764895954554e-08 -0.09378395239715098 +1.1321 0.6960359318324434 0.6960336858310374 -6.734018960941751e-08 -0.09378578204270331 +1.1322 0.6960392163444188 0.6960369711052865 -7.779832770712924e-08 -0.09378761116697894 +1.1322999999999999 0.6960424997945223 0.696040255538608 -8.824584281277165e-08 -0.09378943977011618 +1.1324 0.6960457821831543 0.6960435391311259 -9.868040148214297e-08 -0.09379126785225338 +1.1325 0.6960490635107397 0.6960468218829392 -1.0909967373875368e-07 -0.09379309541352886 +1.1326 0.696052343777727 0.6960501037941218 -1.1950133357516157e-07 -0.09379492245408079 +1.1327 0.6960556229845904 0.6960533848647239 -1.2988305949507284e-07 -0.09379674897404751 +1.1328 0.6960589011318281 0.6960566650947705 -1.4024253501034034e-07 -0.09379857497356717 +1.1329 0.6960621782199621 0.6960599444842619 -1.5057744916571747e-07 -0.09380040045277789 +1.133 0.6960654542495396 0.6960632230331745 -1.6088549705840782e-07 -0.0938022254118179 +1.1331000000000002 0.6960687292211316 0.69606650074146 -1.7116438033766557e-07 -0.09380404985082524 +1.1332 0.6960720031353334 0.6960697776090461 -1.8141180773909027e-07 -0.09380587376993804 +1.1333 0.6960752759927639 0.6960730536358362 -1.9162549559637032e-07 -0.09380769716929432 +1.1334000000000002 0.6960785477940667 0.6960763288217091 -2.0180316830792355e-07 -0.09380952004903209 +1.1335 0.696081818539909 0.6960796031665204 -2.1194255890935598e-07 -0.09381134240928934 +1.1336000000000002 0.6960850882309816 0.6960828766701006 -2.220414095227552e-07 -0.09381316425020396 +1.1337000000000002 0.6960883568679994 0.6960861493322577 -2.3209747188057683e-07 -0.09381498557191398 +1.1338 0.6960916244517008 0.6960894211527747 -2.421085078356533e-07 -0.0938168063745572 +1.1339000000000001 0.6960948909828476 0.6960926921314122 -2.5207228984344687e-07 -0.09381862665827152 +1.134 0.6960981564622248 0.6960959622679066 -2.61986601468589e-07 -0.09382044642319481 +1.1341 0.6961014208906411 0.696099231561971 -2.718492378636639e-07 -0.0938222656694648 +1.1342 0.6961046842689278 0.696102500013295 -2.816580062861562e-07 -0.09382408439721932 +1.1342999999999999 0.6961079465979395 0.6961057676215454 -2.914107265737653e-07 -0.09382590260659601 +1.1344 0.6961112078785539 0.6961090343863661 -3.011052316023721e-07 -0.09382772029773266 +1.1345 0.6961144681116707 0.6961123003073779 -3.107393677925785e-07 -0.09382953747076689 +1.1346 0.6961177272982132 0.6961155653841793 -3.2031099559542975e-07 -0.09383135412583647 +1.1347 0.696120985439126 0.6961188296163459 -3.298179899954845e-07 -0.09383317026307891 +1.1348 0.6961242425353764 0.6961220930034311 -3.392582408820455e-07 -0.09383498588263178 +1.1349 0.6961274985879542 0.696125355544966 -3.486296536250877e-07 -0.09383680098463272 +1.135 0.6961307535978705 0.6961286172404594 -3.579301494846532e-07 -0.09383861556921916 +1.1351000000000002 0.6961340075661584 0.6961318780893988 -3.6715766606881806e-07 -0.09384042963652867 +1.1352 0.6961372604938725 0.6961351380912495 -3.763101578471706e-07 -0.0938422431866986 +1.1353 0.6961405123820891 0.6961383972454558 -3.8538559648387816e-07 -0.09384405621986656 +1.1354000000000002 0.6961437632319054 0.6961416555514401 -3.943819714621877e-07 -0.09384586873616985 +1.1355 0.6961470130444394 0.6961449130086039 -4.0329729038973694e-07 -0.09384768073574581 +1.1356000000000002 0.6961502618208302 0.6961481696163281 -4.1212957951203277e-07 -0.09384949221873179 +1.1357000000000002 0.6961535095622376 0.6961514253739723 -4.208768840732735e-07 -0.09385130318526518 +1.1358 0.6961567562698417 0.6961546802808761 -4.295372688506438e-07 -0.0938531136354832 +1.1359000000000001 0.6961600019448425 0.6961579343363583 -4.381088184735038e-07 -0.09385492356952305 +1.136 0.6961632465884602 0.6961611875397178 -4.465896379993173e-07 -0.09385673298752197 +1.1361 0.6961664902019351 0.6961644398902336 -4.5497785314263517e-07 -0.0938585418896172 +1.1362 0.6961697327865266 0.6961676913871656 -4.6327161083020707e-07 -0.09386035027594591 +1.1362999999999999 0.6961729743435134 0.6961709420297533 -4.7146907955486483e-07 -0.09386215814664516 +1.1364 0.6961762148741935 0.6961741918172177 -4.795684498404285e-07 -0.09386396550185208 +1.1365 0.6961794543798836 0.6961774407487602 -4.875679345331396e-07 -0.09386577234170373 +1.1366 0.6961826928619187 0.6961806888235644 -4.954657692596287e-07 -0.09386757866633712 +1.1367 0.6961859303216527 0.6961839360407946 -5.032602128293706e-07 -0.09386938447588929 +1.1368 0.6961891667604574 0.6961871823995971 -5.10949547609385e-07 -0.09387118977049717 +1.1369 0.6961924021797221 0.6961904278991005 -5.185320798919979e-07 -0.09387299455029768 +1.137 0.6961956365808544 0.6961936725384152 -5.260061402417859e-07 -0.09387479881542782 +1.1371000000000002 0.6961988699652785 0.6961969163166348 -5.333700839327271e-07 -0.09387660256602441 +1.1372 0.6962021023344362 0.6962001592328354 -5.406222912535119e-07 -0.09387840580222434 +1.1373 0.6962053336897855 0.6962034012860759 -5.477611679099992e-07 -0.0938802085241644 +1.1374000000000002 0.6962085640328017 0.696206642475399 -5.547851452680774e-07 -0.09388201073198138 +1.1375 0.6962117933649759 0.6962098827998306 -5.61692680867143e-07 -0.09388381242581209 +1.1376000000000002 0.6962150216878149 0.696213122258381 -5.684822586421445e-07 -0.0938856136057932 +1.1377000000000002 0.6962182490028415 0.6962163608500439 -5.751523892982835e-07 -0.09388741427206138 +1.1378 0.6962214753115938 0.6962195985737982 -5.817016106024475e-07 -0.09388921442475333 +1.1379000000000001 0.6962247006156256 0.6962228354286079 -5.881284877023996e-07 -0.09389101406400574 +1.138 0.6962279249165044 0.6962260714134209 -5.944316135292338e-07 -0.09389281318995515 +1.1381000000000001 0.6962311482158131 0.696229306527171 -6.006096089916646e-07 -0.09389461180273814 +1.1382 0.6962343705151484 0.696232540768778 -6.066611233368491e-07 -0.09389640990249126 +1.1382999999999999 0.6962375918161211 0.6962357741371475 -6.125848344418205e-07 -0.09389820748935102 +1.1384 0.6962408121203554 0.6962390066311712 -6.183794491187999e-07 -0.09390000456345392 +1.1385 0.6962440314294892 0.6962422382497272 -6.240437033511181e-07 -0.09390180112493642 +1.1386 0.696247249745173 0.6962454689916812 -6.295763626124051e-07 -0.09390359717393497 +1.1387 0.6962504670690701 0.6962486988558849 -6.349762221580235e-07 -0.09390539271058584 +1.1388 0.6962536834028559 0.696251927841179 -6.402421071222131e-07 -0.09390718773502553 +1.1389 0.6962568987482185 0.6962551559463908 -6.453728730315689e-07 -0.0939089822473903 +1.139 0.6962601131068571 0.6962583831703363 -6.50367405888308e-07 -0.09391077624781646 +1.1391000000000002 0.6962633264804823 0.69626160951182 -6.552246223784364e-07 -0.0939125697364403 +1.1392 0.6962665388708162 0.6962648349696353 -6.599434702603268e-07 -0.09391436271339804 +1.1393 0.6962697502795916 0.6962680595425644 -6.645229285312526e-07 -0.09391615517882593 +1.1394000000000002 0.6962729607085509 0.696271283229379 -6.689620075245317e-07 -0.09391794713286006 +1.1395 0.6962761701594478 0.6962745060288411 -6.732597492842274e-07 -0.09391973857563665 +1.1396000000000002 0.6962793786340442 0.6962777279397023 -6.774152277455592e-07 -0.09392152950729178 +1.1397 0.6962825861341129 0.696280948960705 -6.814275488459254e-07 -0.09392331992796157 +1.1398 0.6962857926614351 0.6962841690905823 -6.852958507330698e-07 -0.09392510983778207 +1.1399000000000001 0.6962889982178002 0.6962873883280587 -6.890193041259041e-07 -0.0939268992368893 +1.14 0.6962922028050067 0.6962906066718497 -6.925971122034857e-07 -0.09392868812541921 +1.1401000000000001 0.6962954064248609 0.6962938241206633 -6.960285110629849e-07 -0.09393047650350783 +1.1402 0.6962986090791765 0.6962970406731992 -6.993127697196844e-07 -0.09393226437129104 +1.1402999999999999 0.6963018107697749 0.6963002563281502 -7.024491902318797e-07 -0.09393405172890479 +1.1404 0.6963050114984843 0.6963034710842015 -7.054371079368016e-07 -0.09393583857648496 +1.1405 0.6963082112671395 0.6963066849400318 -7.082758916310272e-07 -0.0939376249141674 +1.1406 0.6963114100775813 0.6963098978943134 -7.10964943514969e-07 -0.09393941074208788 +1.1407 0.6963146079316567 0.6963131099457123 -7.135036995398192e-07 -0.09394119606038216 +1.1408 0.6963178048312182 0.6963163210928894 -7.158916294491835e-07 -0.09394298086918604 +1.1409 0.6963210007781235 0.6963195313345001 -7.181282368207142e-07 -0.09394476516863526 +1.141 0.696324195774235 0.6963227406691942 -7.202130591493772e-07 -0.0939465489588654 +1.1411000000000002 0.6963273898214195 0.696325949095618 -7.221456681250071e-07 -0.09394833224001226 +1.1412 0.6963305829215483 0.696329156612413 -7.239256695490415e-07 -0.0939501150122114 +1.1413 0.6963337750764957 0.6963323632182167 -7.255527035426867e-07 -0.09395189727559841 +1.1414000000000002 0.6963369662881405 0.6963355689116633 -7.270264444220187e-07 -0.09395367903030893 +1.1415 0.696340156558363 0.6963387736913841 -7.283466010449269e-07 -0.09395546027647839 +1.1416000000000002 0.6963433458890476 0.6963419775560072 -7.295129166029479e-07 -0.09395724101424241 +1.1417 0.6963465342820798 0.6963451805041585 -7.305251688294323e-07 -0.09395902124373638 +1.1418 0.6963497217393478 0.6963483825344619 -7.313831699023998e-07 -0.09396080096509578 +1.1419000000000001 0.6963529082627413 0.6963515836455397 -7.32086766680462e-07 -0.09396258017845605 +1.142 0.6963560938541506 0.6963547838360127 -7.32635840647311e-07 -0.09396435888395252 +1.1421000000000001 0.6963592785154675 0.6963579831045006 -7.330303077451861e-07 -0.09396613708172061 +1.1422 0.6963624622485837 0.6963611814496229 -7.332701186940627e-07 -0.09396791477189559 +1.1422999999999999 0.6963656450553913 0.696364378869999 -7.333552587557302e-07 -0.0939696919546128 +1.1424 0.6963688269377821 0.696367575364248 -7.33285747844814e-07 -0.09397146863000748 +1.1425 0.6963720078976471 0.6963707709309896 -7.33061640459387e-07 -0.09397324479821485 +1.1426 0.6963751879368762 0.6963739655688448 -7.326830256809691e-07 -0.09397502045937013 +1.1427 0.6963783670573584 0.6963771592764354 -7.321500272300385e-07 -0.09397679561360853 +1.1428 0.6963815452609806 0.6963803520523852 -7.314628032994985e-07 -0.09397857026106515 +1.1429 0.6963847225496274 0.6963835438953196 -7.306215466101884e-07 -0.09398034440187508 +1.143 0.6963878989251813 0.6963867348038668 -7.296264841888389e-07 -0.09398211803617351 +1.1431000000000002 0.6963910743895219 0.6963899247766572 -7.284778776039946e-07 -0.09398389116409539 +1.1432 0.6963942489445251 0.6963931138123247 -7.271760225913138e-07 -0.09398566378577576 +1.1433 0.6963974225920638 0.6963963019095063 -7.257212492339793e-07 -0.09398743590134961 +1.1434000000000002 0.6964005953340071 0.696399489066843 -7.241139216712655e-07 -0.09398920751095191 +1.1435 0.6964037671722192 0.6964026752829803 -7.22354438167927e-07 -0.0939909786147176 +1.1436000000000002 0.6964069381085601 0.6964058605565675 -7.204432309337871e-07 -0.09399274921278158 +1.1437 0.6964101081448846 0.6964090448862594 -7.183807659849606e-07 -0.09399451930527873 +1.1438 0.6964132772830423 0.6964122282707156 -7.161675431577308e-07 -0.09399628889234385 +1.1439000000000001 0.6964164455248769 0.6964154107086016 -7.138040958726277e-07 -0.09399805797411181 +1.144 0.6964196128722262 0.6964185921985886 -7.112909910927945e-07 -0.09399982655071737 +1.1441000000000001 0.6964227793269213 0.6964217727393542 -7.086288290741871e-07 -0.09400159462229522 +1.1442 0.6964259448907869 0.696424952329583 -7.058182433655746e-07 -0.09400336218898013 +1.1442999999999999 0.6964291095656401 0.696428130967966 -7.028599005309832e-07 -0.09400512925090676 +1.1444 0.696432273353291 0.6964313086532017 -6.997545001358185e-07 -0.0940068958082098 +1.1445 0.6964354362555417 0.6964344853839965 -6.965027744137986e-07 -0.09400866186102382 +1.1446 0.6964385982741861 0.6964376611590652 -6.931054881836873e-07 -0.09401042740948348 +1.1447 0.6964417594110093 0.69644083597713 -6.895634387521499e-07 -0.09401219245372333 +1.1448 0.6964449196677884 0.6964440098369229 -6.85877455497419e-07 -0.09401395699387789 +1.1449 0.6964480790462904 0.6964471827371839 -6.820483999941951e-07 -0.09401572103008171 +1.145 0.6964512375482729 0.6964503546766634 -6.780771655418016e-07 -0.0940174845624692 +1.1451000000000002 0.6964543951754845 0.6964535256541208 -6.739646770254071e-07 -0.09401924759117485 +1.1452 0.6964575519296625 0.6964566956683258 -6.697118907494914e-07 -0.09402101011633303 +1.1453 0.6964607078125343 0.6964598647180588 -6.653197942296796e-07 -0.09402277213807818 +1.1454000000000002 0.6964638628258164 0.6964630328021104 -6.607894059568187e-07 -0.09402453365654462 +1.1455 0.696467016971214 0.6964661999192827 -6.561217750500337e-07 -0.09402629467186668 +1.1456000000000002 0.6964701702504208 0.6964693660683892 -6.513179811734604e-07 -0.0940280551841787 +1.1457 0.6964733226651187 0.6964725312482545 -6.463791341476677e-07 -0.09402981519361489 +1.1458 0.6964764742169776 0.6964756954577156 -6.413063738108793e-07 -0.09403157470030947 +1.1459000000000001 0.6964796249076544 0.6964788586956223 -6.361008697275405e-07 -0.0940333337043967 +1.146 0.696482774738794 0.696482020960836 -6.307638208968847e-07 -0.0940350922060107 +1.1461000000000001 0.6964859237120282 0.6964851822522318 -6.252964553365992e-07 -0.09403685020528563 +1.1462 0.6964890718289747 0.6964883425686978 -6.197000301244593e-07 -0.0940386077023556 +1.1462999999999999 0.6964922190912379 0.696491501909136 -6.139758309126053e-07 -0.09404036469735472 +1.1464 0.6964953655004087 0.6964946602724618 -6.081251715944758e-07 -0.09404212119041702 +1.1465 0.696498511058063 0.6964978176576045 -6.021493939717404e-07 -0.09404387718167652 +1.1466 0.6965016557657626 0.6965009740635089 -5.960498677543002e-07 -0.09404563267126725 +1.1467 0.6965047996250542 0.6965041294891332 -5.898279898247649e-07 -0.09404738765932309 +1.1468 0.6965079426374692 0.6965072839334518 -5.834851842662081e-07 -0.09404914214597802 +1.1469 0.6965110848045241 0.6965104373954537 -5.770229017515449e-07 -0.09405089613136593 +1.147 0.6965142261277193 0.6965135898741435 -5.704426194602652e-07 -0.09405264961562067 +1.1471000000000002 0.6965173666085397 0.6965167413685422 -5.637458406620999e-07 -0.0940544025988762 +1.1472 0.696520506248453 0.696519891877686 -5.569340942590539e-07 -0.09405615508126614 +1.1473 0.6965236450489114 0.6965230414006287 -5.500089345494841e-07 -0.09405790706292438 +1.1474000000000002 0.6965267830113496 0.6965261899364397 -5.429719408533984e-07 -0.09405965854398468 +1.1475 0.6965299201371857 0.6965293374842056 -5.358247172071451e-07 -0.09406140952458072 +1.1476000000000002 0.6965330564278203 0.6965324840430308 -5.285688918638121e-07 -0.09406316000484621 +1.1477 0.6965361918846364 0.6965356296120362 -5.212061170017934e-07 -0.0940649099849148 +1.1478 0.6965393265089993 0.6965387741903608 -5.137380683847836e-07 -0.09406665946492009 +1.1479000000000001 0.6965424603022563 0.6965419177771619 -5.061664449315662e-07 -0.09406840844499573 +1.148 0.6965455932657361 0.6965450603716143 -4.984929683898853e-07 -0.09407015692527526 +1.1481000000000001 0.6965487254007494 0.6965482019729119 -4.907193827952128e-07 -0.09407190490589226 +1.1482 0.6965518567085878 0.6965513425802662 -4.828474542625805e-07 -0.09407365238698018 +1.1482999999999999 0.6965549871905234 0.6965544821929086 -4.748789704384082e-07 -0.09407539936867247 +1.1484 0.6965581168478101 0.6965576208100894 -4.6681574020907e-07 -0.09407714585110265 +1.1485 0.6965612456816821 0.6965607584310776 -4.586595932151716e-07 -0.0940788918344041 +1.1486 0.6965643736933533 0.6965638950551623 -4.504123794421555e-07 -0.09408063731871023 +1.1487 0.6965675008840186 0.6965670306816523 -4.4207596887335665e-07 -0.0940823823041544 +1.1488 0.6965706272548521 0.6965701653098758 -4.3365225096958504e-07 -0.0940841267908699 +1.1489 0.6965737528070081 0.696573298939182 -4.2514313428054784e-07 -0.09408587077899001 +1.149 0.6965768775416203 0.6965764315689398 -4.165505460632102e-07 -0.09408761426864809 +1.1491000000000002 0.6965800014598017 0.6965795631985389 -4.078764317475003e-07 -0.09408935725997732 +1.1492 0.6965831245626446 0.6965826938273896 -3.991227545616094e-07 -0.09409109975311089 +1.1493 0.6965862468512198 0.6965858234549231 -3.9029149510177996e-07 -0.09409284174818196 +1.1494000000000002 0.6965893683265776 0.6965889520805918 -3.8138465083964457e-07 -0.09409458324532372 +1.1495 0.6965924889897465 0.6965920797038694 -3.724042356781365e-07 -0.09409632424466927 +1.1496000000000002 0.6965956088417333 0.6965952063242509 -3.6335227953515625e-07 -0.0940980647463517 +1.1497 0.6965987278835236 0.6965983319412529 -3.542308277953987e-07 -0.09409980475050406 +1.1498 0.6966018461160808 0.6966014565544135 -3.450419409564698e-07 -0.09410154425725939 +1.1499000000000001 0.696604963540346 0.6966045801632934 -3.3578769415010257e-07 -0.09410328326675065 +1.15 0.6966080801572386 0.6966077027674746 -3.264701765870459e-07 -0.09410502177911084 +1.1501000000000001 0.6966111959676555 0.6966108243665619 -3.1709149116848634e-07 -0.09410675979447286 +1.1502000000000001 0.6966143109724707 0.6966139449601821 -3.076537539586921e-07 -0.09410849731296962 +1.1502999999999999 0.6966174251725368 0.6966170645479846 -2.9815909377561844e-07 -0.09411023433473403 +1.1504 0.6966205385686824 0.696620183129641 -2.8860965160804053e-07 -0.09411197085989893 +1.1505 0.6966236511617139 0.6966233007048463 -2.7900758022697536e-07 -0.09411370688859709 +1.1506 0.6966267629524145 0.696626417273318 -2.69355043682612e-07 -0.09411544242096131 +1.1507 0.6966298739415446 0.6966295328347966 -2.59654216780425e-07 -0.09411717745712439 +1.1508 0.6966329841298409 0.6966326473890454 -2.4990728462320755e-07 -0.094118911997219 +1.1509 0.6966360935180173 0.6966357609358514 -2.4011644208024596e-07 -0.09412064604137785 +1.151 0.6966392021067638 0.6966388734750246 -2.302838933640472e-07 -0.0941223795897336 +1.1511000000000002 0.6966423098967476 0.6966419850063983 -2.2041185145441067e-07 -0.0941241126424189 +1.1512 0.6966454168886114 0.6966450955298292 -2.1050253766474736e-07 -0.0941258451995663 +1.1513 0.6966485230829753 0.6966482050451979 -2.0055818108696832e-07 -0.09412757726130844 +1.1514000000000002 0.6966516284804352 0.696651313552408 -1.9058101815086492e-07 -0.09412930882777781 +1.1515 0.6966547330815626 0.6966544210513874 -1.805732920689973e-07 -0.09413103989910694 +1.1516000000000002 0.6966578368869059 0.6966575275420877 -1.7053725236138018e-07 -0.09413277047542834 +1.1517 0.6966609398969896 0.6966606330244839 -1.604751543298616e-07 -0.09413450055687445 +1.1518 0.6966640421123138 0.6966637374985749 -1.5038925857066565e-07 -0.09413623014357769 +1.1519000000000001 0.6966671435333545 0.6966668409643837 -1.402818304557102e-07 -0.09413795923567042 +1.152 0.6966702441605639 0.6966699434219575 -1.301551396399453e-07 -0.09413968783328502 +1.1521000000000001 0.6966733439943699 0.6966730448713674 -1.200114595270585e-07 -0.09414141593655385 +1.1522000000000001 0.6966764430351764 0.6966761453127082 -1.0985306676467022e-07 -0.09414314354560921 +1.1522999999999999 0.6966795412833631 0.6966792447460989 -9.96822407655501e-08 -0.09414487066058336 +1.1524 0.696682638739285 0.6966823431716825 -8.95012631481687e-08 -0.09414659728160847 +1.1525 0.6966857354032739 0.6966854405896268 -7.931241725444432e-08 -0.09414832340881692 +1.1526 0.6966888312756364 0.696688537000123 -6.911798763886701e-08 -0.09415004904234076 +1.1527 0.6966919263566553 0.6966916324033863 -5.892025953680574e-08 -0.09415177418231219 +1.1528 0.696695020646589 0.6966947267996567 -4.872151837184702e-08 -0.09415349882886331 +1.1529 0.6966981141456712 0.6966978201891978 -3.852404923320937e-08 -0.0941552229821262 +1.153 0.6967012068541124 0.6967009125722976 -2.8330136367469422e-08 -0.09415694664223297 +1.1531000000000002 0.6967042987720979 0.696704003949268 -1.814206266595106e-08 -0.09415866980931559 +1.1532 0.6967073898997898 0.696707094320445 -7.96210915341572e-09 -0.09416039248350608 +1.1533 0.696710480237325 0.6967101836861891 2.207445521512641e-09 -0.0941621146649365 +1.1534 0.6967135697848168 0.6967132720468843 1.236432559548889e-08 -0.09416383635373873 +1.1535 0.6967166585423539 0.6967163594029386 2.2506258705659588e-08 -0.09416555755004463 +1.1536000000000002 0.6967197465100018 0.6967194457547843 3.263097638969703e-08 -0.09416727825398616 +1.1537 0.6967228336878011 0.6967225311028771 4.273621460014476e-08 -0.0941689984656951 +1.1538 0.6967259200757687 0.6967256154476971 5.281971420835474e-08 -0.09417071818530331 +1.1539000000000001 0.696729005673898 0.6967286987897481 6.287922149975089e-08 -0.09417243741294261 +1.154 0.6967320904821579 0.6967317811295572 7.29124886977156e-08 -0.09417415614874469 +1.1541000000000001 0.6967351745004939 0.6967348624676757 8.291727445278174e-08 -0.09417587439284135 +1.1542000000000001 0.6967382577288279 0.696737942804678 9.289134433876356e-08 -0.09417759214536425 +1.1542999999999999 0.696741340167058 0.6967410221411625 1.0283247136796958e-07 -0.0941793094064451 +1.1544 0.6967444218150585 0.6967441004777506 1.1273843647519044e-07 -0.09418102617621553 +1.1545 0.6967475026726806 0.6967471778150871 1.2260702901209508e-07 -0.09418274245480714 +1.1546 0.6967505827397515 0.6967502541538404 1.324360472468311e-07 -0.09418445824235148 +1.1547 0.6967536620160765 0.6967533294947017 1.4222329885321683e-07 -0.09418617353898015 +1.1548 0.6967567405014363 0.6967564038383856 1.5196660141381102e-07 -0.0941878883448247 +1.1549 0.6967598181955892 0.6967594771856289 1.6166378287441052e-07 -0.09418960266001657 +1.155 0.6967628950982705 0.696762549537192 1.713126820609978e-07 -0.0941913164846872 +1.1551000000000002 0.6967659712091929 0.6967656208938575 1.8091114914117745e-07 -0.0941930298189681 +1.1552 0.6967690465280456 0.696768691256431 1.904570461133681e-07 -0.0941947426629906 +1.1553 0.6967721210544964 0.69677176062574 1.9994824727864735e-07 -0.0941964550168861 +1.1554 0.6967751947881899 0.6967748290026348 2.093826397125964e-07 -0.09419816688078597 +1.1555 0.6967782677287486 0.6967778963879872 2.1875812374061443e-07 -0.09419987825482147 +1.1556000000000002 0.6967813398757727 0.696780962782692 2.2807261338547713e-07 -0.09420158913912391 +1.1557 0.6967844112288409 0.6967840281876653 2.3732403688081494e-07 -0.09420329953382461 +1.1558 0.6967874817875096 0.6967870926038444 2.4651033707356884e-07 -0.09420500943905467 +1.1559000000000001 0.6967905515513134 0.6967901560321892 2.5562947194440744e-07 -0.09420671885494532 +1.156 0.696793620519766 0.6967932184736803 2.646794149824272e-07 -0.09420842778162775 +1.1561000000000001 0.6967966886923591 0.6967962799293195 2.736581557194473e-07 -0.09421013621923303 +1.1562000000000001 0.6967997560685637 0.6967993404001303 2.825637000908321e-07 -0.09421184416789237 +1.1562999999999999 0.69680282264783 0.6968023998871564 2.9139407097672487e-07 -0.09421355162773683 +1.1564 0.6968058884295869 0.6968054583914622 3.0014730853511473e-07 -0.09421525859889739 +1.1565 0.6968089534132422 0.6968085159141331 3.088214707361314e-07 -0.09421696508150507 +1.1566 0.6968120175981847 0.696811572456274 3.1741463371592893e-07 -0.09421867107569086 +1.1567 0.696815080983782 0.6968146280190108 3.2592489226240806e-07 -0.09422037658158572 +1.1568 0.6968181435693819 0.6968176826034889 3.343503601829778e-07 -0.09422208159932063 +1.1569 0.6968212053543124 0.6968207362108729 3.4268917076946126e-07 -0.09422378612902642 +1.157 0.6968242663378814 0.6968237888423477 3.509394771866736e-07 -0.09422549017083394 +1.1571000000000002 0.6968273265193781 0.6968268404991169 3.590994528887559e-07 -0.09422719372487402 +1.1572 0.6968303858980724 0.6968298911824036 3.671672920077529e-07 -0.09422889679127747 +1.1573 0.6968334444732152 0.6968329408934495 3.751412097907636e-07 -0.0942305993701751 +1.1574 0.6968365022440384 0.6968359896335148 3.830194429677025e-07 -0.09423230146169764 +1.1575 0.6968395592097559 0.6968390374038782 3.9080025014681663e-07 -0.09423400306597583 +1.1576000000000002 0.696842615369563 0.6968420842058367 3.9848191220326346e-07 -0.09423570418314037 +1.1577 0.6968456707226371 0.6968451300407047 4.0606273262605574e-07 -0.09423740481332185 +1.1578 0.6968487252681377 0.6968481749098147 4.135410379482729e-07 -0.09423910495665096 +1.1579000000000002 0.6968517790052068 0.6968512188145164 4.209151781078835e-07 -0.09424080461325823 +1.158 0.6968548319329693 0.6968542617561765 4.281835267530565e-07 -0.09424250378327426 +1.1581000000000001 0.6968578840505328 0.6968573037361789 4.353444816793117e-07 -0.09424420246682957 +1.1582000000000001 0.6968609353569886 0.6968603447559242 4.423964651209533e-07 -0.0942459006640547 +1.1582999999999999 0.6968639858514107 0.6968633848168289 4.4933792417434226e-07 -0.09424759837508004 +1.1584 0.6968670355328581 0.6968664239203259 4.56167331019941e-07 -0.09424929560003613 +1.1585 0.6968700844003728 0.6968694620678643 4.6288318336640266e-07 -0.09425099233905332 +1.1586 0.6968731324529815 0.6968724992609079 4.694840047420046e-07 -0.09425268859226206 +1.1587 0.6968761796896954 0.6968755355009366 4.7596834480689854e-07 -0.09425438435979266 +1.1588 0.6968792261095106 0.6968785707894446 4.82334779727811e-07 -0.09425607964177542 +1.1589 0.6968822717114084 0.6968816051279416 4.885819123723323e-07 -0.09425777443834067 +1.159 0.6968853164943556 0.696884638517951 4.947083728085166e-07 -0.09425946874961871 +1.1591000000000002 0.6968883604573048 0.696887670961011 5.007128183881493e-07 -0.09426116257573976 +1.1592 0.6968914035991944 0.696890702458673 5.065939342324688e-07 -0.09426285591683399 +1.1593 0.6968944459189491 0.6968937330125027 5.123504333154338e-07 -0.09426454877303164 +1.1594 0.6968974874154805 0.6968967626240781 5.179810569494459e-07 -0.09426624114446282 +1.1595 0.6969005280876867 0.6968997912949911 5.234845749241268e-07 -0.0942679330312576 +1.1596000000000002 0.6969035679344534 0.6969028190268457 5.288597858948973e-07 -0.09426962443354615 +1.1597 0.6969066069546538 0.6969058458212585 5.341055175495102e-07 -0.09427131535145851 +1.1598 0.696909645147149 0.6969088716798577 5.392206268439725e-07 -0.09427300578512471 +1.1599000000000002 0.6969126825107879 0.6969118966042838 5.442040003217352e-07 -0.09427469573467472 +1.16 0.6969157190444082 0.6969149205961882 5.490545543357372e-07 -0.09427638520023851 +1.1601000000000001 0.6969187547468362 0.6969179436572338 5.537712353259616e-07 -0.09427807418194603 +1.1602000000000001 0.6969217896168878 0.6969209657890941 5.583530199165798e-07 -0.09427976267992724 +1.1602999999999999 0.6969248236533674 0.6969239869934528 5.627989152490187e-07 -0.09428145069431193 +1.1604 0.6969278568550703 0.6969270072720041 5.671079592595163e-07 -0.09428313822523002 +1.1605 0.696930889220781 0.6969300266264518 5.712792206791217e-07 -0.09428482527281129 +1.1606 0.6969339207492746 0.6969330450585086 5.753117994361512e-07 -0.0942865118371855 +1.1607 0.6969369514393173 0.6969360625698977 5.792048266978211e-07 -0.09428819791848247 +1.1608 0.6969399812896663 0.69693907916235 5.829574652449487e-07 -0.09428988351683197 +1.1609 0.6969430102990699 0.696942094837605 5.865689094164406e-07 -0.09429156863236358 +1.161 0.6969460384662685 0.6969451095974106 5.900383855395042e-07 -0.0942932532652071 +1.1611000000000002 0.696949065789994 0.6969481234435226 5.933651518463812e-07 -0.09429493741549208 +1.1612 0.6969520922689717 0.6969511363777037 5.965484987796588e-07 -0.09429662108334814 +1.1613 0.6969551179019192 0.6969541484017236 5.995877491032919e-07 -0.09429830426890494 +1.1614 0.6969581426875469 0.6969571595173598 6.024822580968925e-07 -0.09429998697229193 +1.1615 0.696961166624559 0.6969601697263952 6.05231413625118e-07 -0.09430166919363868 +1.1616000000000002 0.6969641897116536 0.696963179030619 6.078346362486942e-07 -0.0943033509330747 +1.1617 0.6969672119475229 0.6969661874318267 6.102913794603371e-07 -0.09430503219072943 +1.1618 0.6969702333308534 0.6969691949318181 6.126011296847533e-07 -0.09430671296673232 +1.1619000000000002 0.6969732538603268 0.6969722015323989 6.147634064590513e-07 -0.09430839326121276 +1.162 0.6969762735346198 0.6969752072353792 6.16777762488252e-07 -0.09431007307430014 +1.1621000000000001 0.6969792923524045 0.6969782120425733 6.186437837979453e-07 -0.09431175240612379 +1.1622000000000001 0.6969823103123494 0.6969812159557993 6.203610897204115e-07 -0.09431343125681302 +1.1622999999999999 0.6969853274131188 0.6969842189768795 6.219293330333997e-07 -0.0943151096264971 +1.1624 0.6969883436533741 0.6969872211076388 6.233482000295165e-07 -0.09431678751530533 +1.1625 0.6969913590317733 0.6969902223499056 6.246174105578595e-07 -0.09431846492336697 +1.1626 0.696994373546972 0.69699322270551 6.257367181489171e-07 -0.09432014185081114 +1.1627 0.6969973871976232 0.6969962221762852 6.267059100145689e-07 -0.09432181829776703 +1.1628 0.6970003999823781 0.6969992207640656 6.275248069509409e-07 -0.09432349426436376 +1.1629 0.6970034118998865 0.6970022184706872 6.281932636437171e-07 -0.09432516975073046 +1.163 0.6970064229487964 0.6970052152979873 6.287111684599722e-07 -0.0943268447569962 +1.1631000000000002 0.6970094331277561 0.6970082112478038 6.290784435730723e-07 -0.09432851928329 +1.1632 0.697012442435412 0.6970112063219751 6.292950449765522e-07 -0.09433019332974098 +1.1633 0.6970154508704114 0.6970142005223394 6.293609624979934e-07 -0.09433186689647804 +1.1634 0.6970184584314009 0.6970171938507346 6.292762196741242e-07 -0.09433353998363009 +1.1635 0.6970214651170283 0.6970201863089982 6.29040873820208e-07 -0.09433521259132613 +1.1636000000000002 0.6970244709259427 0.6970231778989666 6.286550160855553e-07 -0.09433688471969509 +1.1637 0.6970274758567934 0.6970261686224748 6.281187712869896e-07 -0.09433855636886584 +1.1638 0.6970304799082319 0.6970291584813556 6.274322979782365e-07 -0.09434022753896716 +1.1639000000000002 0.6970334830789119 0.6970321474774401 6.265957883666573e-07 -0.0943418982301279 +1.164 0.6970364853674886 0.6970351356125573 6.25609468216104e-07 -0.0943435684424768 +1.1641000000000001 0.6970394867726213 0.6970381228885325 6.244735968191639e-07 -0.09434523817614265 +1.1642000000000001 0.697042487292971 0.6970411093071883 6.231884669832821e-07 -0.09434690743125417 +1.1643 0.6970454869272031 0.6970440948703438 6.217544049336166e-07 -0.09434857620794004 +1.1644 0.6970484856739858 0.6970470795798143 6.201717702158938e-07 -0.09435024450632891 +1.1645 0.6970514835319923 0.6970500634374106 6.184409555437531e-07 -0.09435191232654941 +1.1646 0.6970544804998997 0.6970530464449392 6.165623867709913e-07 -0.09435357966873019 +1.1647 0.6970574765763904 0.6970560286042013 6.145365228638067e-07 -0.0943552465329998 +1.1648 0.6970604717601513 0.6970590099169933 6.123638556371214e-07 -0.09435691291948678 +1.1649 0.6970634660498753 0.6970619903851056 6.10044909768459e-07 -0.09435857882831965 +1.165 0.6970664594442613 0.6970649700103224 6.075802425203891e-07 -0.09436024425962686 +1.1651000000000002 0.697069451942014 0.6970679487944225 6.049704437960379e-07 -0.09436190921353693 +1.1652 0.6970724435418449 0.697070926739177 6.022161358060218e-07 -0.09436357369017828 +1.1653 0.6970754342424721 0.6970739038463505 5.99317973151714e-07 -0.09436523768967928 +1.1654 0.6970784240426211 0.6970768801177003 5.962766424227883e-07 -0.0943669012121683 +1.1655 0.6970814129410248 0.6970798555549758 5.930928622249754e-07 -0.09436856425777365 +1.1656000000000002 0.6970844009364243 0.6970828301599186 5.897673828608729e-07 -0.09437022682662366 +1.1657 0.6970873880275689 0.6970858039342616 5.863009862883128e-07 -0.09437188891884662 +1.1658 0.6970903742132164 0.6970887768797294 5.826944858566829e-07 -0.09437355053457075 +1.1659000000000002 0.6970933594921335 0.6970917489980375 5.789487261265158e-07 -0.09437521167392435 +1.166 0.6970963438630957 0.6970947202908915 5.750645827445888e-07 -0.09437687233703547 +1.1661000000000001 0.6970993273248887 0.6970976907599884 5.710429620275903e-07 -0.09437853252403235 +1.1662000000000001 0.697102309876308 0.6971006604070142 5.668848011008976e-07 -0.09438019223504317 +1.1663 0.6971052915161589 0.6971036292336452 5.625910673434653e-07 -0.09438185147019595 +1.1664 0.6971082722432573 0.6971065972415468 5.581627584433368e-07 -0.0943835102296188 +1.1665 0.6971112520564302 0.6971095644323735 5.536009018702881e-07 -0.09438516851343975 +1.1666 0.697114230954516 0.6971125308077682 5.489065549035832e-07 -0.09438682632178683 +1.1667 0.6971172089363635 0.6971154963693629 5.440808042433964e-07 -0.09438848365478797 +1.1668 0.6971201860008345 0.6971184611187772 5.391247657748899e-07 -0.09439014051257118 +1.1669 0.6971231621468019 0.6971214250576185 5.340395843739243e-07 -0.09439179689526436 +1.167 0.697126137373152 0.6971243881874823 5.288264336295034e-07 -0.09439345280299545 +1.1671 0.6971291116787828 0.6971273505099503 5.23486515455196e-07 -0.09439510823589226 +1.1672 0.6971320850626059 0.6971303120265919 5.180210599503576e-07 -0.09439676319408265 +1.1673 0.6971350575235458 0.6971332727389628 5.124313250670642e-07 -0.09439841767769443 +1.1674 0.6971380290605405 0.6971362326486046 5.067185963880672e-07 -0.09440007168685527 +1.1675 0.6971409996725424 0.6971391917570462 5.008841866549485e-07 -0.09440172522169311 +1.1676000000000002 0.6971439693585177 0.697142150065801 4.949294356015876e-07 -0.09440337828233557 +1.1677 0.6971469381174471 0.6971451075763682 4.888557097459945e-07 -0.09440503086891029 +1.1678 0.6971499059483257 0.697148064290232 4.826644018629533e-07 -0.09440668298154498 +1.1679000000000002 0.6971528728501641 0.6971510202088622 4.763569306787119e-07 -0.0944083346203673 +1.168 0.6971558388219878 0.6971539753337124 4.699347408432253e-07 -0.09440998578550476 +1.1681000000000001 0.6971588038628378 0.6971569296662212 4.6339930218075587e-07 -0.094411636477085 +1.1682000000000001 0.6971617679717712 0.697159883207811 4.567521096759952e-07 -0.09441328669523558 +1.1683 0.6971647311478606 0.6971628359598877 4.499946830646695e-07 -0.09441493644008392 +1.1684 0.6971676933901957 0.6971657879238415 4.4312856622291674e-07 -0.0944165857117576 +1.1685 0.697170654697882 0.6971687391010454 4.3615532720892025e-07 -0.094418234510384 +1.1686 0.6971736150700422 0.6971716894928557 4.290765576869804e-07 -0.0944198828360906 +1.1687 0.6971765745058158 0.6971746391006113 4.218938725458754e-07 -0.09442153068900475 +1.1688 0.6971795330043601 0.6971775879256337 4.146089097045724e-07 -0.0944231780692538 +1.1689 0.6971824905648494 0.6971805359692269 4.07223329487727e-07 -0.09442482497696512 +1.169 0.6971854471864762 0.6971834832326773 3.9973881452159965e-07 -0.09442647141226605 +1.1691 0.6971884028684503 0.6971864297172528 3.921570690956777e-07 -0.09442811737528381 +1.1692 0.6971913576100006 0.6971893754242027 3.8447981896144734e-07 -0.09442976286614563 +1.1693 0.697194311410374 0.6971923203547582 3.767088108189154e-07 -0.09443140788497878 +1.1694 0.6971972642688362 0.6971952645101314 3.6884581203211475e-07 -0.09443305243191043 +1.1695 0.6972002161846715 0.6971982078915158 3.6089261009480955e-07 -0.09443469650706775 +1.1696000000000002 0.6972031671571837 0.697201150500085 3.5285101238069494e-07 -0.09443634011057779 +1.1697 0.6972061171856958 0.6972040923369939 3.447228455813467e-07 -0.09443798324256776 +1.1698 0.6972090662695499 0.6972070334033773 3.365099553731543e-07 -0.09443962590316467 +1.1699000000000002 0.6972120144081084 0.6972099737003505 3.2821420602874296e-07 -0.09444126809249556 +1.17 0.6972149616007532 0.6972129132290085 3.19837479924312e-07 -0.09444290981068747 +1.1701000000000001 0.6972179078468863 0.6972158519904262 3.1138167709554576e-07 -0.0944445510578673 +1.1702000000000001 0.6972208531459302 0.6972187899856584 3.0284871493230225e-07 -0.09444619183416209 +1.1703 0.6972237974973274 0.697221727215739 2.9424052758880714e-07 -0.0944478321396987 +1.1704 0.6972267409005416 0.6972246636816813 2.8555906566446465e-07 -0.09444947197460411 +1.1705 0.6972296833550569 0.6972275993844779 2.768062956903794e-07 -0.09445111133900515 +1.1706 0.6972326248603782 0.6972305343250997 2.6798419975465615e-07 -0.09445275023302861 +1.1707 0.6972355654160319 0.6972334685044972 2.5909477495422717e-07 -0.09445438865680135 +1.1708 0.6972385050215654 0.6972364019235988 2.501400330132131e-07 -0.09445602661045009 +1.1709 0.6972414436765475 0.6972393345833119 2.411219998874059e-07 -0.09445766409410161 +1.171 0.6972443813805687 0.697242266484522 2.3204271515364638e-07 -0.09445930110788264 +1.1711 0.6972473181332411 0.6972451976280927 2.2290423161430706e-07 -0.09446093765191983 +1.1712 0.6972502539341987 0.697248128014866 2.1370861486708082e-07 -0.09446257372633989 +1.1713 0.6972531887830973 0.6972510576456614 2.0445794288170838e-07 -0.09446420933126938 +1.1714 0.6972561226796152 0.6972539865212763 1.9515430542058065e-07 -0.09446584446683501 +1.1715 0.6972590556234524 0.697256914642486 1.8579980360158843e-07 -0.09446747913316322 +1.1716000000000002 0.6972619876143313 0.6972598420100431 1.7639654943321648e-07 -0.09446911333038065 +1.1717 0.6972649186519968 0.6972627686246777 1.6694666536351543e-07 -0.0944707470586137 +1.1718 0.6972678487362167 0.6972656944870979 1.5745228377009313e-07 -0.094472380317989 +1.1719000000000002 0.6972707778667809 0.6972686195979876 1.4791554648826977e-07 -0.0944740131086329 +1.172 0.6972737060435021 0.697271543958009 1.3833860432535539e-07 -0.09447564543067184 +1.1721000000000001 0.6972766332662164 0.6972744675678015 1.287236165922745e-07 -0.09447727728423222 +1.1722000000000001 0.697279559534782 0.6972773904279806 1.1907275058661848e-07 -0.09447890866944043 +1.1723 0.6972824848490805 0.6972803125391394 1.0938818113467863e-07 -0.09448053958642279 +1.1724 0.6972854092090168 0.6972832339018474 9.967209006755962e-08 -0.09448217003530564 +1.1725 0.6972883326145184 0.6972861545166512 8.992666576321251e-08 -0.0944838000162152 +1.1726 0.6972912550655362 0.6972890743840736 8.015410263642608e-08 -0.09448542952927776 +1.1727 0.6972941765620445 0.6972919935046145 7.03566006583084e-08 -0.09448705857461946 +1.1728 0.6972970971040408 0.6972949118787503 6.053636484454339e-08 -0.09448868715236661 +1.1729 0.6973000166915456 0.6972978295069335 5.069560476619883e-08 -0.09449031526264524 +1.173 0.6973029353246036 0.6973007463895939 4.083653404839127e-08 -0.0944919429055816 +1.1731 0.6973058530032823 0.6973036625271369 3.096136988456344e-08 -0.09449357008130171 +1.1732 0.6973087697276728 0.6973065779199449 2.1072332526475557e-08 -0.09449519678993168 +1.1733 0.6973116854978896 0.6973094925683764 1.1171644795013314e-08 -0.09449682303159751 +1.1734 0.6973146003140709 0.6973124064727665 1.2615315658423554e-09 -0.09449844880642527 +1.1735 0.6973175141763784 0.6973153196334262 -8.65578071284484e-09 -0.09450007411454092 +1.1736000000000002 0.6973204270849976 0.6973182320506436 -1.8578064533373434e-08 -0.09450169895607047 +1.1737 0.697323339040137 0.697321143724682 -2.8503091823849774e-08 -0.09450332333113975 +1.1738 0.697326250042029 0.6973240546557824 -3.842863445079753e-08 -0.09450494723987474 +1.1739000000000002 0.697329160090929 0.6973269648441613 -4.8352464714936224e-08 -0.09450657068240127 +1.174 0.6973320691871168 0.6973298742900116 -5.8272355855579216e-08 -0.09450819365884516 +1.1741000000000001 0.6973349773308952 0.6973327829935023 -6.81860825462767e-08 -0.09450981616933223 +1.1742000000000001 0.6973378845225907 0.6973356909547797 -7.809142139880709e-08 -0.0945114382139883 +1.1743 0.6973407907625531 0.6973385981739655 -8.798615145841349e-08 -0.09451305979293906 +1.1744 0.6973436960511554 0.6973415046511586 -9.786805470375637e-08 -0.09451468090631027 +1.1745 0.6973466003887947 0.6973444103864341 -1.0773491653133516e-07 -0.09451630155422758 +1.1746 0.6973495037758909 0.6973473153798435 -1.17584526278941e-07 -0.09451792173681672 +1.1747 0.6973524062128875 0.697350219631415 -1.2741467770097104e-07 -0.0945195414542033 +1.1747999999999998 0.697355307700251 0.6973531231411532 -1.3722316946282453e-07 -0.0945211607065129 +1.1749 0.6973582082384713 0.6973560259090397 -1.4700780563529914e-07 -0.09452277949387111 +1.175 0.6973611078280615 0.6973589279350327 -1.567663962011301e-07 -0.09452439781640348 +1.1751 0.6973640064695574 0.6973618292190671 -1.6649675752163084e-07 -0.09452601567423552 +1.1752 0.6973669041635184 0.697364729761055 -1.7619671283455873e-07 -0.09452763306749273 +1.1753 0.6973698009105261 0.697367629560885 -1.8586409275545002e-07 -0.09452924999630055 +1.1754 0.6973726967111857 0.6973705286184233 -1.9549673574079107e-07 -0.09453086646078444 +1.1755 0.6973755915661244 0.6973734269335126 -2.0509248858241458e-07 -0.09453248246106977 +1.1756000000000002 0.6973784854759929 0.6973763245059732 -2.146492069018957e-07 -0.09453409799728192 +1.1757 0.6973813784414635 0.6973792213356027 -2.2416475557382465e-07 -0.09453571306954624 +1.1758 0.6973842704632317 0.6973821174221763 -2.336370093017348e-07 -0.094537327677988 +1.1759000000000002 0.6973871615420151 0.6973850127654462 -2.430638529858642e-07 -0.09453894182273256 +1.176 0.6973900516785536 0.6973879073651428 -2.5244318228173634e-07 -0.09454055550390514 +1.1761000000000001 0.697392940873609 0.6973908012209737 -2.6177290402690234e-07 -0.09454216872163095 +1.1762000000000001 0.6973958291279654 0.6973936943326251 -2.7105093668503e-07 -0.0945437814760352 +1.1763 0.6973987164424285 0.6973965866997606 -2.802752108732598e-07 -0.09454539376724304 +1.1764000000000001 0.6974016028178256 0.6973994783220223 -2.8944366976466074e-07 -0.09454700559537961 +1.1765 0.6974044882550063 0.6974023691990303 -2.9855426962599463e-07 -0.09454861696057004 +1.1766 0.6974073727548408 0.6974052593303838 -3.0760498014037463e-07 -0.09455022786293941 +1.1767 0.6974102563182211 0.6974081487156596 -3.165937850144185e-07 -0.09455183830261275 +1.1767999999999998 0.6974131389460602 0.6974110373544139 -3.2551868231478487e-07 -0.09455344827971508 +1.1769 0.6974160206392921 0.6974139252461816 -3.3437768492960984e-07 -0.09455505779437141 +1.177 0.6974189013988717 0.6974168123904769 -3.4316882110280167e-07 -0.09455666684670674 +1.1771 0.6974217812257746 0.6974196987867928 -3.5189013476710773e-07 -0.09455827543684592 +1.1772 0.6974246601209962 0.6974225844346018 -3.6053968600208153e-07 -0.09455988356491389 +1.1773 0.6974275380855535 0.6974254693333566 -3.691155514781719e-07 -0.09456149123103556 +1.1774 0.6974304151204824 0.6974283534824884 -3.776158249216288e-07 -0.09456309843533574 +1.1775 0.6974332912268396 0.6974312368814095 -3.8603861751002055e-07 -0.09456470517793925 +1.1776000000000002 0.6974361664057012 0.697434119529512 -3.9438205820530037e-07 -0.09456631145897088 +1.1777 0.6974390406581628 0.6974370014261676 -4.026442943505515e-07 -0.0945679172785554 +1.1778 0.6974419139853395 0.6974398825707295 -4.108234919336651e-07 -0.09456952263681756 +1.1779000000000002 0.6974447863883654 0.697442762962531 -4.189178360244905e-07 -0.09457112753388199 +1.178 0.6974476578683937 0.697445642600887 -4.269255312258635e-07 -0.09457273196987341 +1.1781000000000001 0.6974505284265966 0.6974485214850927 -4.3484480203442866e-07 -0.09457433594491646 +1.1782000000000001 0.6974533980641644 0.6974513996144251 -4.4267389322921735e-07 -0.09457593945913575 +1.1783 0.6974562667823059 0.6974542769881429 -4.5041107028104266e-07 -0.09457754251265589 +1.1784000000000001 0.6974591345822478 0.6974571536054861 -4.580546197549551e-07 -0.09457914510560142 +1.1785 0.6974620014652348 0.6974600294656772 -4.656028496086151e-07 -0.09458074723809679 +1.1786 0.6974648674325297 0.6974629045679207 -4.7305408967801554e-07 -0.09458234891026664 +1.1787 0.6974677324854119 0.6974657789114036 -4.804066919619765e-07 -0.09458395012223532 +1.1787999999999998 0.6974705966251784 0.697468652495296 -4.876590310107232e-07 -0.09458555087412736 +1.1789 0.6974734598531429 0.6974715253187507 -4.948095043283418e-07 -0.09458715116606717 +1.179 0.697476322170636 0.697474397380903 -5.018565326642133e-07 -0.09458875099817902 +1.1791 0.6974791835790046 0.697477268680873 -5.087985603738354e-07 -0.09459035037058738 +1.1792 0.6974820440796117 0.6974801392177636 -5.156340558212791e-07 -0.09459194928341652 +1.1793 0.6974849036738361 0.6974830089906621 -5.223615116289881e-07 -0.09459354773679073 +1.1794 0.6974877623630727 0.6974858779986395 -5.289794450524798e-07 -0.09459514573083429 +1.1795 0.6974906201487314 0.697488746240752 -5.354863983342284e-07 -0.09459674326567145 +1.1796000000000002 0.6974934770322372 0.6974916137160403 -5.418809389950985e-07 -0.09459834034142636 +1.1797 0.6974963330150301 0.6974944804235299 -5.481616601882289e-07 -0.09459993695822326 +1.1798 0.6974991880985646 0.6974973463622318 -5.543271808794437e-07 -0.09460153311618628 +1.1799000000000002 0.6975020422843095 0.6975002115311428 -5.603761463607304e-07 -0.09460312881543956 +1.18 0.6975048955737474 0.6975030759292454 -5.663072283473847e-07 -0.09460472405610715 +1.1801000000000001 0.6975077479683748 0.6975059395555081 -5.721191253943436e-07 -0.09460631883831311 +1.1802000000000001 0.697510599469702 0.697508802408886 -5.778105631459862e-07 -0.0946079131621815 +1.1803 0.6975134500792517 0.6975116644883212 -5.833802946275668e-07 -0.09460950702783633 +1.1804000000000001 0.69751629979856 0.6975145257927424 -5.888271004672596e-07 -0.09461110043540158 +1.1805 0.6975191486291756 0.6975173863210656 -5.941497892708592e-07 -0.09461269338500118 +1.1806 0.6975219965726589 0.697520246072195 -5.993471977050469e-07 -0.09461428587675906 +1.1807 0.6975248436305825 0.6975231050450224 -6.044181909276025e-07 -0.09461587791079909 +1.1807999999999998 0.6975276898045315 0.6975259632384274 -6.093616628233267e-07 -0.0946174694872452 +1.1809 0.6975305350961007 0.6975288206512787 -6.141765360734297e-07 -0.09461906060622109 +1.181 0.6975333795068972 0.6975316772824338 -6.188617625579873e-07 -0.09462065126785064 +1.1811 0.6975362230385382 0.6975345331307391 -6.234163235502299e-07 -0.0946222414722576 +1.1812 0.6975390656926519 0.6975373881950306 -6.278392299247093e-07 -0.09462383121956572 +1.1813 0.6975419074708761 0.6975402424741342 -6.321295223515877e-07 -0.09462542050989875 +1.1814 0.6975447483748587 0.6975430959668658 -6.362862715048045e-07 -0.09462700934338035 +1.1815 0.6975475884062565 0.6975459486720315 -6.403085783257545e-07 -0.09462859772013414 +1.1816000000000002 0.6975504275667364 0.6975488005884285 -6.441955741204319e-07 -0.0946301856402838 +1.1817 0.6975532658579728 0.6975516517148452 -6.479464208924979e-07 -0.09463177310395292 +1.1818 0.69755610328165 0.6975545020500613 -6.515603113294022e-07 -0.0946333601112651 +1.1819000000000002 0.6975589398394594 0.6975573515928476 -6.550364691076949e-07 -0.09463494666234383 +1.182 0.6975617755331007 0.6975602003419675 -6.583741490734374e-07 -0.09463653275731262 +1.1821000000000002 0.6975646103642809 0.6975630482961768 -6.615726373115915e-07 -0.09463811839629498 +1.1822000000000001 0.6975674443347142 0.6975658954542241 -6.646312513819419e-07 -0.09463970357941433 +1.1823 0.6975702774461219 0.6975687418148508 -6.675493403884847e-07 -0.09464128830679416 +1.1824000000000001 0.697573109700231 0.6975715873767918 -6.703262852014724e-07 -0.09464287257855777 +1.1825 0.6975759410987757 0.6975744321387757 -6.729614984990473e-07 -0.09464445639482859 +1.1826 0.6975787716434956 0.6975772760995254 -6.754544250447969e-07 -0.09464603975572997 +1.1827 0.6975816013361353 0.6975801192577579 -6.77804541576732e-07 -0.09464762266138521 +1.1827999999999999 0.6975844301784453 0.6975829616121851 -6.800113571125976e-07 -0.0946492051119176 +1.1829 0.6975872581721803 0.6975858031615139 -6.820744129082401e-07 -0.09465078710745035 +1.183 0.6975900853190996 0.6975886439044469 -6.839932826935291e-07 -0.09465236864810674 +1.1831 0.6975929116209667 0.697591483839682 -6.857675726862356e-07 -0.0946539497340099 +1.1832 0.6975957370795487 0.697594322965914 -6.873969216752984e-07 -0.09465553036528304 +1.1833 0.6975985616966165 0.6975971612818334 -6.888810010208246e-07 -0.09465711054204934 +1.1834 0.6976013854739435 0.6975999987861277 -6.902195149038892e-07 -0.09465869026443181 +1.1835 0.697604208413306 0.6976028354774817 -6.914122002016354e-07 -0.09466026953255353 +1.1836000000000002 0.6976070305164831 0.697605671354578 -6.924588266260523e-07 -0.09466184834653768 +1.1837 0.6976098517852553 0.6976085064160966 -6.933591967656083e-07 -0.09466342670650715 +1.1838 0.6976126722214051 0.697611340660716 -6.941131461546401e-07 -0.09466500461258498 +1.1839000000000002 0.6976154918267162 0.697614174087113 -6.947205431762082e-07 -0.09466658206489413 +1.184 0.6976183106029735 0.6976170066939636 -6.951812892008746e-07 -0.09466815906355755 +1.1841000000000002 0.6976211285519621 0.6976198384799428 -6.954953186005808e-07 -0.09466973560869812 +1.1842000000000001 0.6976239456754679 0.6976226694437255 -6.956625987070142e-07 -0.09467131170043874 +1.1843 0.6976267619752761 0.6976254995839862 -6.956831297560973e-07 -0.09467288733890221 +1.1844000000000001 0.6976295774531722 0.6976283288994003 -6.955569450406429e-07 -0.09467446252421145 +1.1845 0.6976323921109402 0.6976311573886431 -6.952841107438212e-07 -0.09467603725648917 +1.1846 0.6976352059503637 0.6976339850503914 -6.948647260085483e-07 -0.09467761153585817 +1.1847 0.6976380189732241 0.6976368118833229 -6.942989228680974e-07 -0.09467918536244112 +1.1847999999999999 0.6976408311813014 0.6976396378861179 -6.935868662044653e-07 -0.09468075873636078 +1.1849 0.6976436425763733 0.697642463057458 -6.92728753734495e-07 -0.09468233165773983 +1.185 0.6976464531602153 0.6976452873960273 -6.917248158988532e-07 -0.0946839041267009 +1.1851 0.6976492629345995 0.6976481109005128 -6.90575315848152e-07 -0.0946854761433666 +1.1852 0.6976520719012951 0.6976509335696047 -6.892805494290721e-07 -0.09468704770785956 +1.1853 0.6976548800620674 0.6976537554019961 -6.878408449484397e-07 -0.09468861882030222 +1.1854 0.6976576874186788 0.6976565763963847 -6.862565632981266e-07 -0.09469018948081727 +1.1855 0.6976604939728865 0.6976593965514715 -6.845280976913726e-07 -0.09469175968952714 +1.1856000000000002 0.6976632997264431 0.6976622158659626 -6.826558736072741e-07 -0.09469332944655429 +1.1857 0.6976661046810966 0.6976650343385684 -6.80640348804662e-07 -0.09469489875202118 +1.1858 0.69766890883859 0.6976678519680051 -6.784820130861791e-07 -0.09469646760605024 +1.1859000000000002 0.6976717122006602 0.6976706687529937 -6.76181388187258e-07 -0.09469803600876381 +1.186 0.697674514769038 0.6976734846922616 -6.737390276512212e-07 -0.09469960396028432 +1.1861000000000002 0.6976773165454485 0.6976762997845418 -6.711555168431582e-07 -0.09470117146073403 +1.1862000000000001 0.6976801175316102 0.6976791140285744 -6.684314726307372e-07 -0.09470273851023531 +1.1863 0.6976829177292343 0.6976819274231059 -6.6556754328706e-07 -0.0947043051089104 +1.1864000000000001 0.6976857171400246 0.6976847399668897 -6.625644083518845e-07 -0.09470587125688151 +1.1865 0.6976885157656776 0.6976875516586877 -6.594227784789686e-07 -0.09470743695427092 +1.1866 0.6976913136078817 0.6976903624972687 -6.561433952417817e-07 -0.09470900220120076 +1.1867 0.6976941106683174 0.6976931724814097 -6.527270310086042e-07 -0.09471056699779323 +1.1867999999999999 0.6976969069486562 0.6976959816098969 -6.49174488789872e-07 -0.09471213134417046 +1.1869 0.6976997024505608 0.6976987898815243 -6.454866018495986e-07 -0.09471369524045453 +1.187 0.6977024971756847 0.6977015972950958 -6.41664233747008e-07 -0.0947152586867675 +1.1871 0.6977052911256718 0.6977044038494242 -6.37708278017346e-07 -0.09471682168323142 +1.1872 0.6977080843021564 0.6977072095433328 -6.336196580053466e-07 -0.09471838422996831 +1.1873 0.6977108767067621 0.6977100143756538 -6.293993266154319e-07 -0.09471994632710017 +1.1874 0.6977136683411027 0.6977128183452306 -6.250482661174228e-07 -0.09472150797474893 +1.1875 0.6977164592067804 0.6977156214509171 -6.205674878967393e-07 -0.09472306917303651 +1.1876000000000002 0.697719249305387 0.6977184236915785 -6.159580322323555e-07 -0.09472462992208486 +1.1877 0.6977220386385026 0.6977212250660906 -6.112209680747549e-07 -0.09472619022201578 +1.1878 0.6977248272076956 0.6977240255733412 -6.063573927961308e-07 -0.09472775007295117 +1.1879000000000002 0.6977276150145225 0.6977268252122301 -6.013684318573187e-07 -0.09472930947501285 +1.188 0.6977304020605273 0.6977296239816688 -5.962552386828968e-07 -0.09473086842832254 +1.1881000000000002 0.6977331883472416 0.697732421880582 -5.910189942448518e-07 -0.09473242693300205 +1.1882000000000001 0.6977359738761841 0.6977352189079065 -5.856609069376795e-07 -0.0947339849891731 +1.1883 0.6977387586488604 0.6977380150625925 -5.801822122036837e-07 -0.09473554259695738 +1.1884000000000001 0.6977415426667624 0.6977408103436036 -5.745841723248102e-07 -0.0947370997564766 +1.1885 0.6977443259313685 0.6977436047499166 -5.688680760063125e-07 -0.09473865646785236 +1.1886 0.6977471084441426 0.6977463982805227 -5.630352381824633e-07 -0.09474021273120628 +1.1887 0.6977498902065347 0.6977491909344267 -5.570869997112426e-07 -0.09474176854665987 +1.1887999999999999 0.6977526712199809 0.6977519827106482 -5.510247270967827e-07 -0.09474332391433478 +1.1889 0.6977554514859012 0.6977547736082219 -5.448498120314005e-07 -0.09474487883435252 +1.189 0.6977582310057016 0.6977575636261968 -5.385636712221253e-07 -0.09474643330683459 +1.1891 0.6977610097807718 0.6977603527636376 -5.321677460090601e-07 -0.09474798733190246 +1.1892 0.6977637878124867 0.6977631410196241 -5.256635020531308e-07 -0.09474954090967756 +1.1893 0.6977665651022049 0.6977659283932519 -5.190524289613863e-07 -0.09475109404028129 +1.1894 0.6977693416512688 0.6977687148836329 -5.123360399539312e-07 -0.09475264672383502 +1.1895 0.697772117461005 0.6977715004898951 -5.05515871621065e-07 -0.09475419896046015 +1.1896000000000002 0.697774892532723 0.697774285211183 -4.985934834722539e-07 -0.09475575075027802 +1.1897 0.6977776668677155 0.6977770690466579 -4.915704575128577e-07 -0.09475730209340988 +1.1898 0.6977804404672583 0.6977798519954976 -4.844483980567804e-07 -0.09475885298997701 +1.1899000000000002 0.6977832133326097 0.6977826340568978 -4.772289312476863e-07 -0.09476040344010069 +1.19 0.6977859854650108 0.6977854152300711 -4.6991370472593275e-07 -0.09476195344390209 +1.1901000000000002 0.6977887568656842 0.6977881955142478 -4.625043871636647e-07 -0.09476350300150237 +1.1902000000000001 0.6977915275358357 0.6977909749086763 -4.550026680566477e-07 -0.09476505211302276 +1.1903 0.6977942974766518 0.6977937534126231 -4.4741025720385075e-07 -0.09476660077858433 +1.1904000000000001 0.6977970666893012 0.6977965310253724 -4.3972888434662405e-07 -0.09476814899830815 +1.1905 0.6977998351749337 0.6977993077462279 -4.3196029881481524e-07 -0.09476969677231539 +1.1906 0.6978026029346804 0.6978020835745113 -4.24106269096558e-07 -0.09477124410072706 +1.1907 0.6978053699696534 0.6978048585095633 -4.1616858243581634e-07 -0.09477279098366406 +1.1907999999999999 0.6978081362809454 0.6978076325507436 -4.081490444160507e-07 -0.09477433742124747 +1.1909 0.6978109018696304 0.6978104056974316 -4.000494785438846e-07 -0.09477588341359831 +1.191 0.6978136667367616 0.6978131779490255 -3.918717259090987e-07 -0.09477742896083735 +1.1911 0.6978164308833735 0.6978159493049441 -3.8361764469196924e-07 -0.09477897406308561 +1.1912 0.6978191943104802 0.697818719764625 -3.7528910974693463e-07 -0.09478051872046389 +1.1913 0.6978219570190758 0.6978214893275265 -3.66888012227895e-07 -0.09478206293309305 +1.1914 0.6978247190101339 0.6978242579931268 -3.5841625908167307e-07 -0.09478360670109391 +1.1915 0.6978274802846081 0.6978270257609247 -3.498757727010693e-07 -0.09478515002458729 +1.1916000000000002 0.6978302408434308 0.697829792630439 -3.4126849039056717e-07 -0.09478669290369386 +1.1917 0.6978330006875142 0.6978325586012097 -3.325963640263274e-07 -0.09478823533853445 +1.1918 0.6978357598177493 0.6978353236727968 -3.2386135956352646e-07 -0.09478977732922966 +1.1919000000000002 0.697838518235006 0.6978380878447824 -3.150654565714506e-07 -0.09479131887590023 +1.192 0.6978412759401331 0.6978408511167686 -3.062106478379789e-07 -0.09479285997866672 +1.1921000000000002 0.6978440329339584 0.6978436134883794 -2.9729893889079984e-07 -0.09479440063764985 +1.1922000000000001 0.6978467892172875 0.6978463749592598 -2.8833234753250503e-07 -0.09479594085297016 +1.1923 0.697849544790905 0.6978491355290765 -2.793129033895614e-07 -0.0947974806247482 +1.1924000000000001 0.6978522996555734 0.6978518951975174 -2.7024264747863014e-07 -0.09479901995310447 +1.1925 0.6978550538120336 0.6978546539642925 -2.6112363171737485e-07 -0.09480055883815947 +1.1926 0.6978578072610051 0.6978574118291332 -2.5195791846302495e-07 -0.09480209728003369 +1.1927 0.6978605600031844 0.6978601687917934 -2.4274758006828656e-07 -0.09480363527884758 +1.1927999999999999 0.6978633120392463 0.6978629248520487 -2.3349469837827264e-07 -0.09480517283472156 +1.1929 0.6978660633698439 0.697865680009697 -2.24201364272536e-07 -0.09480670994777604 +1.193 0.6978688139956069 0.6978684342645578 -2.1486967723485795e-07 -0.09480824661813131 +1.1931 0.697871563917143 0.6978711876164736 -2.055017448154839e-07 -0.09480978284590771 +1.1932 0.6978743131350379 0.6978739400653088 -1.9609968216968698e-07 -0.09481131863122555 +1.1933 0.6978770616498543 0.6978766916109507 -1.8666561163796502e-07 -0.09481285397420512 +1.1934 0.6978798094621324 0.6978794422533086 -1.7720166219092892e-07 -0.09481438887496661 +1.1935 0.6978825565723896 0.697882191992315 -1.677099689852135e-07 -0.0948159233336303 +1.1936000000000002 0.6978853029811206 0.6978849408279247 -1.581926728812244e-07 -0.09481745735031638 +1.1937 0.6978880486887971 0.697887688760115 -1.4865191995741545e-07 -0.09481899092514491 +1.1938 0.6978907936958686 0.6978904357888862 -1.3908986103323973e-07 -0.09482052405823611 +1.1939000000000002 0.6978935380027609 0.6978931819142613 -1.2950865116781451e-07 -0.0948220567497101 +1.194 0.697896281609877 0.6978959271362863 -1.1991044918113758e-07 -0.09482358899968688 +1.1941000000000002 0.6978990245175974 0.6978986714550302 -1.1029741718397712e-07 -0.09482512080828653 +1.1942000000000002 0.697901766726279 0.6979014148705842 -1.0067172006786307e-07 -0.09482665217562904 +1.1943 0.6979045082362559 0.6979041573830631 -9.10355250289055e-08 -0.09482818310183443 +1.1944000000000001 0.6979072490478394 0.6979068989926045 -8.139100108120467e-08 -0.09482971358702263 +1.1945 0.6979099891613172 0.6979096396993687 -7.174031856765906e-08 -0.09483124363131357 +1.1946 0.6979127285769543 0.6979123795035395 -6.208564866556909e-08 -0.09483277323482718 +1.1947 0.6979154672949925 0.6979151184053229 -5.242916290741986e-08 -0.09483430239768331 +1.1947999999999999 0.6979182053156506 0.6979178564049486 -4.2773032685834364e-08 -0.09483583112000177 +1.1949 0.6979209426391242 0.6979205935026689 -3.311942876839304e-08 -0.09483735940190245 +1.195 0.6979236792655861 0.697923329698759 -2.3470520809417555e-08 -0.09483888724350512 +1.1951 0.6979264151951854 0.6979260649935172 -1.3828476860561906e-08 -0.09484041464492948 +1.1952 0.6979291504280491 0.6979287993872645 -4.195462885957235e-09 -0.09484194160629533 +1.1953 0.6979318849642804 0.6979315328803453 5.4263577242696925e-09 -0.09484346812772232 +1.1954 0.6979346188039601 0.697934265473126 1.5034824639610644e-08 -0.09484499420933017 +1.1955 0.6979373519471455 0.6979369971659966 2.4627781080970024e-08 -0.09484651985123846 +1.1956000000000002 0.6979400843938717 0.6979397279593695 3.420307428947389e-08 -0.09484804505356687 +1.1957 0.6979428161441505 0.6979424578536799 4.37585560286724e-08 -0.094849569816435 +1.1958 0.6979455471979712 0.6979451868493857 5.329208304684363e-08 -0.09485109413996239 +1.1959000000000002 0.6979482775553 0.6979479149469672 6.280151757832864e-08 -0.09485261802426853 +1.196 0.6979510072160808 0.6979506421469275 7.228472780583528e-08 -0.094854141469473 +1.1961000000000002 0.6979537361802348 0.697953368449792 8.173958834269135e-08 -0.09485566447569523 +1.1962000000000002 0.6979564644476604 0.6979560938561087 9.116398071509768e-08 -0.09485718704305464 +1.1963 0.697959192018234 0.6979588183664478 1.0055579384091184e-07 -0.09485870917167072 +1.1964000000000001 0.6979619188918091 0.6979615419814016 1.099129244702679e-07 -0.09486023086166279 +1.1965 0.697964645068218 0.697964264701585 1.1923327771293235e-07 -0.09486175211315027 +1.1966 0.6979673705472693 0.6979669865276343 1.2851476745290302e-07 -0.09486327292625242 +1.1967 0.697970095328751 0.6979697074602085 1.3775531683066222e-07 -0.09486479330108864 +1.1967999999999999 0.6979728194124282 0.6979724274999879 1.4695285875318542e-07 -0.09486631323777817 +1.1969 0.6979755427980442 0.6979751466476748 1.561053362651721e-07 -0.09486783273644027 +1.197 0.697978265485321 0.6979778649039929 1.652107031110961e-07 -0.09486935179719413 +1.1971 0.6979809874739589 0.6979805822696881 1.742669241272532e-07 -0.09487087042015896 +1.1972 0.6979837087636358 0.6979832987455263 1.832719756927892e-07 -0.0948723886054539 +1.1973 0.6979864293540095 0.6979860143322965 1.9222384622930022e-07 -0.09487390635319812 +1.1974 0.6979891492447158 0.6979887290308073 2.0112053660328866e-07 -0.0948754236635107 +1.1975 0.6979918684353696 0.6979914428418893 2.099600606084162e-07 -0.09487694053651079 +1.1976000000000002 0.6979945869255645 0.6979941557663931 2.1874044540959314e-07 -0.09487845697231728 +1.1977 0.6979973047148739 0.6979968678051911 2.2745973190380075e-07 -0.09487997297104937 +1.1978 0.6980000218028501 0.6979995789591751 2.3611597529255013e-07 -0.09488148853282602 +1.1979000000000002 0.6980027381890248 0.6980022892292581 2.447072454045407e-07 -0.09488300365776609 +1.198 0.6980054538729099 0.698004998616373 2.5323162716056613e-07 -0.09488451834598863 +1.1981000000000002 0.6980081688539963 0.698007707121473 2.6168722103842024e-07 -0.09488603259761251 +1.1982000000000002 0.6980108831317553 0.6980104147455306 2.700721434475972e-07 -0.09488754641275658 +1.1983 0.6980135967056385 0.6980131214895391 2.78384527166442e-07 -0.09488905979153972 +1.1984000000000001 0.6980163095750778 0.6980158273545105 2.8662252172378944e-07 -0.0948905727340808 +1.1985 0.698019021739485 0.6980185323414765 2.947842939055034e-07 -0.09489208524049854 +1.1986 0.6980217331982536 0.698021236451488 3.028680280459106e-07 -0.09489359731091175 +1.1987 0.6980244439507572 0.6980239396856147 3.108719265135229e-07 -0.09489510894543922 +1.1987999999999999 0.6980271539963505 0.6980266420449452 3.187942100996155e-07 -0.09489662014419957 +1.1989 0.6980298633343703 0.6980293435305869 3.2663311834435493e-07 -0.09489813090731153 +1.199 0.698032571964134 0.6980320441436654 3.3438691002946053e-07 -0.09489964123489375 +1.1991 0.698035279884941 0.6980347438853242 3.420538635112713e-07 -0.09490115112706482 +1.1992 0.6980379870960726 0.6980374427567257 3.496322771093241e-07 -0.09490266058394344 +1.1993 0.6980406935967921 0.6980401407590491 3.571204694671759e-07 -0.09490416960564807 +1.1994 0.6980433993863455 0.6980428378934918 3.6451677996179876e-07 -0.09490567819229734 +1.1995 0.6980461044639614 0.6980455341612678 3.718195690297077e-07 -0.0949071863440097 +1.1996000000000002 0.6980488088288505 0.698048229563609 3.790272186179888e-07 -0.09490869406090369 +1.1997 0.6980515124802069 0.6980509241017636 3.861381323716495e-07 -0.0949102013430977 +1.1998 0.6980542154172082 0.6980536177769969 3.9315073618872987e-07 -0.09491170819071022 +1.1999000000000002 0.6980569176390155 0.6980563105905899 4.0006347843540846e-07 -0.09491321460385962 +1.2 0.6980596191447732 0.6980590025438406 4.068748303415193e-07 -0.09491472058266431 +1.2001000000000002 0.69806231993361 0.6980616936380621 4.135832863405575e-07 -0.09491622612724263 +1.2002000000000002 0.6980650200046389 0.6980643838745837 4.201873643125409e-07 -0.09491773123771284 +1.2003 0.6980677193569573 0.6980670732547496 4.2668560608360995e-07 -0.09491923591419328 +1.2004000000000001 0.6980704179896473 0.6980697617799199 4.3307657760643936e-07 -0.09492074015680221 +1.2005 0.6980731159017761 0.6980724494514687 4.3935886933493817e-07 -0.09492224396565786 +1.2006000000000001 0.6980758130923959 0.6980751362707853 4.4553109652262224e-07 -0.0949237473408784 +1.2007 0.6980785095605446 0.6980778222392732 4.515918994862922e-07 -0.09492525028258204 +1.2007999999999999 0.6980812053052463 0.6980805073583499 4.57539944029306e-07 -0.09492675279088693 +1.2009 0.6980839003255106 0.698083191629447 4.633739216081123e-07 -0.09492825486591121 +1.201 0.6980865946203341 0.6980858750540092 4.690925495959286e-07 -0.09492975650777297 +1.2011 0.6980892881886986 0.6980885576334948 4.746945717892803e-07 -0.0949312577165902 +1.2012 0.6980919810295749 0.6980912393693748 4.801787584357564e-07 -0.09493275849248102 +1.2013 0.6980946731419193 0.6980939202631329 4.855439066364653e-07 -0.09493425883556338 +1.2014 0.6980973645246765 0.6980966003162656 4.907888404709349e-07 -0.09493575874595529 +1.2015 0.6981000551767786 0.6980992795302813 4.959124115105906e-07 -0.09493725822377472 +1.2016000000000002 0.6981027450971459 0.6981019579066997 5.00913498804878e-07 -0.09493875726913954 +1.2017 0.6981054342846871 0.6981046354470529 5.057910092559625e-07 -0.09494025588216773 +1.2018 0.6981081227382994 0.6981073121528836 5.105438779240412e-07 -0.09494175406297706 +1.2019000000000002 0.6981108104568692 0.6981099880257458 5.151710679995869e-07 -0.09494325181168546 +1.202 0.6981134974392716 0.6981126630672037 5.196715713862154e-07 -0.0949447491284107 +1.2021000000000002 0.6981161836843721 0.6981153372788322 5.240444086451745e-07 -0.09494624601327056 +1.2022 0.6981188691910256 0.698118010662216 5.282886293561662e-07 -0.09494774246638277 +1.2023 0.6981215539580773 0.6981206832189496 5.324033122144911e-07 -0.09494923848786509 +1.2024000000000001 0.6981242379843626 0.6981233549506367 5.363875653086048e-07 -0.09495073407783518 +1.2025 0.6981269212687085 0.6981260258588905 5.402405262866505e-07 -0.09495222923641079 +1.2026000000000001 0.6981296038099319 0.6981286959453326 5.439613626201378e-07 -0.09495372396370949 +1.2027 0.6981322856068425 0.6981313652115928 5.475492716178199e-07 -0.09495521825984893 +1.2027999999999999 0.6981349666582407 0.6981340336593099 5.510034807587605e-07 -0.09495671212494669 +1.2029 0.6981376469629197 0.6981367012901298 5.543232477478455e-07 -0.09495820555912038 +1.203 0.6981403265196646 0.698139368105706 5.575078607517048e-07 -0.09495969856248745 +1.2031 0.6981430053272534 0.6981420341076989 5.605566385236127e-07 -0.09496119113516543 +1.2032 0.6981456833844574 0.6981446992977762 5.634689305145102e-07 -0.09496268327727181 +1.2033 0.6981483606900409 0.698147363677612 5.66244117053416e-07 -0.09496417498892398 +1.2034 0.6981510372427624 0.6981500272488863 5.688816095139604e-07 -0.09496566627023946 +1.2035 0.6981537130413739 0.6981526900132852 5.71380850356018e-07 -0.09496715712133552 +1.2036000000000002 0.6981563880846221 0.6981553519725004 5.737413133199976e-07 -0.09496864754232964 +1.2037 0.6981590623712484 0.6981580131282283 5.759625034823523e-07 -0.0949701375333391 +1.2038 0.6981617358999893 0.6981606734821706 5.780439573527252e-07 -0.0949716270944812 +1.2039000000000002 0.6981644086695762 0.6981633330360332 5.799852429849706e-07 -0.09497311622587318 +1.204 0.698167080678737 0.6981659917915263 5.817859601298103e-07 -0.09497460492763232 +1.2041000000000002 0.6981697519261949 0.6981686497503641 5.834457402209559e-07 -0.09497609319987585 +1.2042 0.6981724224106702 0.6981713069142642 5.84964246583275e-07 -0.09497758104272098 +1.2043 0.6981750921308794 0.6981739632849475 5.863411742940139e-07 -0.09497906845628491 +1.2044000000000001 0.6981777610855362 0.6981766188641371 5.87576250474231e-07 -0.09498055544068473 +1.2045 0.698180429273352 0.6981792736535593 5.886692340806299e-07 -0.09498204199603755 +1.2046000000000001 0.6981830966930351 0.6981819276549421 5.89619916252504e-07 -0.09498352812246043 +1.2047 0.6981857633432931 0.6981845808700158 5.904281200619366e-07 -0.09498501382007052 +1.2047999999999999 0.6981884292228309 0.6981872333005112 5.910937007913564e-07 -0.09498649908898474 +1.2049 0.6981910943303531 0.6981898849481616 5.91616545780882e-07 -0.09498798392932015 +1.205 0.6981937586645626 0.6981925358146999 5.919965745948552e-07 -0.09498946834119369 +1.2051 0.6981964222241623 0.6981951859018598 5.922337388969412e-07 -0.09499095232472232 +1.2052 0.6981990850078548 0.6981978352113754 5.923280225195171e-07 -0.09499243588002299 +1.2053 0.6982017470143423 0.69820048374498 5.922794414220389e-07 -0.09499391900721245 +1.2054 0.6982044082423287 0.698203131504407 5.92088043718797e-07 -0.09499540170640773 +1.2055 0.6982070686905171 0.6982057784913882 5.917539096650382e-07 -0.09499688397772556 +1.2056000000000002 0.6982097283576132 0.6982084247076547 5.912771515459436e-07 -0.09499836582128278 +1.2057 0.6982123872423234 0.6982110701549354 5.906579138431622e-07 -0.09499984723719614 +1.2058 0.698215045343356 0.698213714834958 5.898963729294993e-07 -0.09500132822558242 +1.2059000000000002 0.6982177026594216 0.6982163587494473 5.889927372770831e-07 -0.09500280878655834 +1.206 0.6982203591892333 0.6982190019001254 5.879472471520542e-07 -0.0950042889202405 +1.2061000000000002 0.6982230149315072 0.6982216442887121 5.867601747255868e-07 -0.0950057686267457 +1.2062 0.6982256698849623 0.6982242859169236 5.85431824060012e-07 -0.0950072479061905 +1.2063 0.6982283240483211 0.6982269267864722 5.839625306924834e-07 -0.09500872675869151 +1.2064000000000001 0.6982309774203103 0.6982295668990663 5.823526620651887e-07 -0.0950102051843653 +1.2065 0.6982336299996608 0.6982322062564105 5.806026169702383e-07 -0.09501168318332849 +1.2066000000000001 0.6982362817851075 0.698234844860204 5.787128256884433e-07 -0.09501316075569755 +1.2067 0.6982389327753906 0.6982374827121414 5.766837499476818e-07 -0.09501463790158893 +1.2067999999999999 0.6982415829692556 0.698240119813912 5.745158825065655e-07 -0.09501611462111918 +1.2069 0.6982442323654532 0.6982427561671996 5.722097474042398e-07 -0.0950175909144047 +1.207 0.6982468809627399 0.6982453917736822 5.697658995718058e-07 -0.09501906678156197 +1.2071 0.6982495287598787 0.6982480266350306 5.671849248184424e-07 -0.09502054222270727 +1.2072 0.6982521757556388 0.6982506607529099 5.644674396232396e-07 -0.095022017237957 +1.2073 0.6982548219487967 0.6982532941289781 5.616140910935652e-07 -0.09502349182742756 +1.2074 0.6982574673381354 0.6982559267648853 5.586255567013865e-07 -0.09502496599123514 +1.2075 0.6982601119224456 0.6982585586622752 5.555025442138817e-07 -0.09502643972949604 +1.2076000000000002 0.6982627557005261 0.6982611898227824 5.52245791415884e-07 -0.09502791304232655 +1.2077 0.6982653986711835 0.698263820248034 5.488560660682484e-07 -0.09502938592984284 +1.2078 0.6982680408332328 0.6982664499396486 5.453341656025401e-07 -0.09503085839216113 +1.2079000000000002 0.698270682185498 0.6982690788992353 5.416809170794012e-07 -0.09503233042939759 +1.208 0.6982733227268119 0.6982717071283946 5.378971768138507e-07 -0.09503380204166828 +1.2081000000000002 0.6982759624560168 0.6982743346287177 5.339838302920175e-07 -0.09503527322908942 +1.2082 0.6982786013719644 0.6982769614017853 5.29941791990729e-07 -0.095036743991777 +1.2083 0.6982812394735168 0.6982795874491687 5.257720051415893e-07 -0.09503821432984712 +1.2084000000000001 0.6982838767595461 0.6982822127724285 5.214754413562783e-07 -0.09503968424341577 +1.2085 0.6982865132289351 0.6982848373731146 5.170531006265522e-07 -0.09504115373259898 +1.2086000000000001 0.6982891488805769 0.6982874612527659 5.125060110328095e-07 -0.09504262279751263 +1.2087 0.6982917837133769 0.6982900844129105 5.078352283971466e-07 -0.0950440914382728 +1.2087999999999999 0.698294417726251 0.6982927068550642 5.030418361723354e-07 -0.09504555965499528 +1.2089 0.698297050918127 0.6982953285807316 4.981269450810011e-07 -0.09504702744779601 +1.209 0.698299683287945 0.6982979495914048 4.930916929074547e-07 -0.09504849481679087 +1.2091 0.6983023148346572 0.6983005698885635 4.879372442617713e-07 -0.09504996176209562 +1.2092 0.6983049455572287 0.6983031894736746 4.826647903022341e-07 -0.09505142828382611 +1.2093 0.6983075754546373 0.6983058083481923 4.772755484161451e-07 -0.09505289438209813 +1.2094 0.6983102045258738 0.6983084265135573 4.717707619977807e-07 -0.09505436005702737 +1.2095 0.6983128327699422 0.6983110439711968 4.6615170007369144e-07 -0.09505582530872952 +1.2096000000000002 0.6983154601858609 0.6983136607225244 4.604196571222907e-07 -0.09505729013732038 +1.2097 0.6983180867726618 0.6983162767689395 4.5457595274772666e-07 -0.09505875454291553 +1.2098 0.6983207125293912 0.6983188921118268 4.4862193127048755e-07 -0.09506021852563062 +1.2099000000000002 0.6983233374551097 0.6983215067525568 4.4255896156086827e-07 -0.09506168208558122 +1.21 0.6983259615488927 0.6983241206924855 4.3638843660182003e-07 -0.095063145222883 +1.2101000000000002 0.6983285848098307 0.6983267339329531 4.301117733432336e-07 -0.09506460793765147 +1.2102 0.6983312072370292 0.6983293464752847 4.237304121676444e-07 -0.09506607023000208 +1.2103 0.6983338288296096 0.69833195832079 4.1724581668900473e-07 -0.09506753210005042 +1.2104000000000001 0.6983364495867087 0.6983345694707626 4.1065947337798336e-07 -0.09506899354791193 +1.2105 0.6983390695074793 0.6983371799264799 4.0397289126359315e-07 -0.095070454573702 +1.2106000000000001 0.6983416885910905 0.6983397896892036 3.971876015307352e-07 -0.0950719151775361 +1.2107 0.6983443068367277 0.6983423987601785 3.903051571663152e-07 -0.09507337535952963 +1.2107999999999999 0.6983469242435933 0.6983450071406321 3.833271327094434e-07 -0.09507483511979792 +1.2109 0.6983495408109063 0.6983476148317757 3.7625512373795633e-07 -0.09507629445845625 +1.211 0.6983521565379026 0.698350221834803 3.690907466394333e-07 -0.09507775337562001 +1.2111 0.6983547714238361 0.6983528281508906 3.6183563811853503e-07 -0.09507921187140446 +1.2112 0.6983573854679772 0.698355433781197 3.5449145493332557e-07 -0.09508066994592479 +1.2113 0.698359998669615 0.6983580387268626 3.4705987347199985e-07 -0.09508212759929621 +1.2114 0.6983626110280563 0.6983606429890108 3.395425893643056e-07 -0.09508358483163398 +1.2115 0.6983652225426258 0.6983632465687459 3.3194131708602637e-07 -0.09508504164305322 +1.2116000000000002 0.6983678332126667 0.698365849467154 3.24257789605098e-07 -0.09508649803366906 +1.2117 0.6983704430375407 0.6983684516853024 3.164937579722138e-07 -0.0950879540035966 +1.2118 0.6983730520166285 0.6983710532242395 3.086509908906132e-07 -0.09508940955295095 +1.2119000000000002 0.6983756601493291 0.6983736540849953 3.0073127435525926e-07 -0.09509086468184715 +1.212 0.6983782674350612 0.6983762542685801 2.9273641122262717e-07 -0.09509231939040025 +1.2121000000000002 0.6983808738732622 0.6983788537759847 2.8466822083600407e-07 -0.0950937736787252 +1.2122 0.6983834794633896 0.6983814526081806 2.7652853852588866e-07 -0.095095227546937 +1.2123 0.6983860842049199 0.6983840507661201 2.6831921529080205e-07 -0.09509668099515062 +1.2124000000000001 0.6983886880973494 0.6983866482507343 2.600421173601375e-07 -0.09509813402348088 +1.2125 0.698391291140195 0.6983892450629353 2.5169912571537667e-07 -0.09509958663204274 +1.2126000000000001 0.6983938933329925 0.6983918412036149 2.4329213567375607e-07 -0.09510103882095099 +1.2127000000000001 0.6983964946752992 0.6983944366736444 2.3482305649968893e-07 -0.09510249059032054 +1.2127999999999999 0.6983990951666919 0.698397031473875 2.262938109884316e-07 -0.09510394194026621 +1.2129 0.6984016948067682 0.6983996256051366 2.177063349248498e-07 -0.0951053928709027 +1.213 0.6984042935951458 0.6984022190682388 2.0906257675729067e-07 -0.09510684338234471 +1.2131 0.698406891531464 0.6984048118639705 2.00364497118799e-07 -0.09510829347470708 +1.2132 0.6984094886153824 0.6984074039930994 1.916140683171086e-07 -0.09510974314810448 +1.2133 0.6984120848465825 0.6984099954563721 1.8281327398075864e-07 -0.0951111924026516 +1.2134 0.6984146802247653 0.6984125862545139 1.7396410858724898e-07 -0.09511264123846301 +1.2135 0.6984172747496543 0.6984151763882286 1.6506857699813415e-07 -0.09511408965565334 +1.2136000000000002 0.6984198684209938 0.6984177658581991 1.5612869396289253e-07 -0.09511553765433715 +1.2137 0.6984224612385498 0.6984203546650865 1.4714648374769546e-07 -0.09511698523462904 +1.2138 0.6984250532021098 0.6984229428095301 1.381239796045819e-07 -0.09511843239664355 +1.2139000000000002 0.6984276443114825 0.6984255302921474 1.2906322335512477e-07 -0.09511987914049508 +1.214 0.698430234566499 0.6984281171135346 1.1996626492205564e-07 -0.0951213254662982 +1.2141000000000002 0.6984328239670119 0.6984307032742654 1.1083516184354214e-07 -0.09512277137416734 +1.2142 0.6984354125128951 0.6984332887748916 1.0167197882562928e-07 -0.09512421686421685 +1.2143 0.6984380002040451 0.698435873615944 9.247878728080305e-08 -0.09512566193656119 +1.2144000000000001 0.6984405870403805 0.6984384577979301 8.325766482492059e-08 -0.09512710659131476 +1.2145 0.6984431730218412 0.6984410413213353 7.40106948660807e-08 -0.09512855082859178 +1.2146000000000001 0.69844575814839 0.6984436241866234 6.473996609634991e-08 -0.09512999464850665 +1.2147000000000001 0.6984483424200114 0.6984462063942352 5.5447572018182956e-08 -0.09513143805117356 +1.2147999999999999 0.6984509258367122 0.69844878794459 4.6135610479516864e-08 -0.0951328810367068 +1.2149 0.6984535083985217 0.6984513688380842 3.680618319672202e-08 -0.09513432360522067 +1.215 0.6984560901054911 0.6984539490750918 2.7461395293165713e-08 -0.09513576575682928 +1.2151 0.6984586709576943 0.698456528655965 1.810335481348957e-08 -0.09513720749164685 +1.2152 0.6984612509552273 0.698459107581032 8.734172245693228e-09 -0.09513864880978745 +1.2153 0.6984638300982083 0.6984616858506006 -6.440399429041843e-10 -0.09514008971136528 +1.2154 0.6984664083867781 0.6984642634649545 -1.0029167798325522e-08 -0.09514153019649431 +1.2155 0.6984689858211002 0.698466840424356 -1.94190963383363e-08 -0.09514297026528878 +1.2156000000000002 0.6984715624013599 0.6984694167290437 -2.881171004510616e-08 -0.09514440991786254 +1.2157 0.6984741381277653 0.6984719923792351 -3.820489332968108e-08 -0.09514584915432972 +1.2158 0.6984767130005467 0.6984745673751237 -4.759653101624227e-08 -0.0951472879748042 +1.2159 0.698479287019957 0.698477141716882 -5.698450881367993e-08 -0.09514872637940003 +1.216 0.6984818601862711 0.6984797154046589 -6.636671379470216e-08 -0.09515016436823108 +1.2161000000000002 0.6984844324997865 0.6984822884385813 -7.574103486800501e-08 -0.09515160194141123 +1.2162 0.6984870039608231 0.6984848608187535 -8.510536325580936e-08 -0.09515303909905433 +1.2163 0.6984895745697228 0.6984874325452577 -9.445759296955458e-08 -0.09515447584127425 +1.2164000000000001 0.6984921443268504 0.6984900036181536 -1.0379562127849074e-07 -0.09515591216818485 +1.2165 0.6984947132325916 0.6984925740374781 -1.1311734918889593e-07 -0.0951573480798998 +1.2166000000000001 0.698497281287356 0.6984951438032467 -1.2242068190421174e-07 -0.09515878357653296 +1.2167000000000001 0.698499848491574 0.6984977129154519 -1.3170352931336782e-07 -0.09516021865819799 +1.2167999999999999 0.6985024148456985 0.6985002813740643 -1.4096380644874895e-07 -0.0951616533250086 +1.2169 0.6985049803502048 0.6985028491790328 -1.5019943394416202e-07 -0.09516308757707856 +1.217 0.6985075450055893 0.6985054163302835 -1.594083385361711e-07 -0.09516452141452142 +1.2171 0.6985101088123711 0.698507982827721 -1.6858845349257412e-07 -0.09516595483745081 +1.2172 0.6985126717710903 0.6985105486712277 -1.7773771908771718e-07 -0.09516738784598033 +1.2173 0.69851523388231 0.6985131138606644 -1.8685408308127816e-07 -0.0951688204402236 +1.2174 0.6985177951466135 0.6985156783958699 -1.959355011606212e-07 -0.09517025262029404 +1.2175 0.6985203555646062 0.6985182422766616 -2.049799374022332e-07 -0.0951716843863052 +1.2176000000000002 0.6985229151369153 0.6985208055028356 -2.1398536472275187e-07 -0.09517311573837067 +1.2177 0.698525473864189 0.6985233680741657 -2.229497653612189e-07 -0.09517454667660377 +1.2178 0.6985280317470968 0.698525929990405 -2.318711312815358e-07 -0.09517597720111798 +1.2179 0.6985305887863291 0.6985284912512851 -2.4074746467553365e-07 -0.0951774073120267 +1.218 0.698533144982598 0.698531051856517 -2.495767783723679e-07 -0.09517883700944334 +1.2181000000000002 0.698535700336636 0.6985336118057897 -2.583570963103632e-07 -0.09518026629348118 +1.2182 0.6985382548491965 0.6985361710987719 -2.670864539637552e-07 -0.09518169516425361 +1.2183 0.6985408085210534 0.6985387297351114 -2.757628987624938e-07 -0.09518312362187382 +1.2184000000000001 0.6985433613530012 0.6985412877144356 -2.8438449057449633e-07 -0.09518455166645512 +1.2185 0.6985459133458551 0.6985438450363513 -2.92949302115042e-07 -0.09518597929811079 +1.2186000000000001 0.6985484645004505 0.6985464017004446 -3.014554193631058e-07 -0.09518740651695401 +1.2187000000000001 0.6985510148176424 0.6985489577062818 -3.099009420401422e-07 -0.09518883332309797 +1.2187999999999999 0.6985535642983062 0.6985515130534088 -3.1828398394662116e-07 -0.0951902597166558 +1.2189 0.6985561129433371 0.6985540677413521 -3.2660267346856786e-07 -0.09519168569774068 +1.219 0.6985586607536495 0.6985566217696179 -3.348551539800182e-07 -0.09519311126646565 +1.2191 0.6985612077301779 0.698559175137693 -3.4303958424547476e-07 -0.09519453642294379 +1.2192 0.6985637538738757 0.6985617278450447 -3.5115413876685153e-07 -0.09519596116728817 +1.2193 0.6985662991857156 0.6985642798911214 -3.591970082900131e-07 -0.09519738549961176 +1.2194 0.698568843666689 0.6985668312753519 -3.671664001725361e-07 -0.09519880942002762 +1.2195 0.6985713873178067 0.6985693819971466 -3.750605387653483e-07 -0.09520023292864861 +1.2196000000000002 0.6985739301400973 0.6985719320558967 -3.8287766582906224e-07 -0.09520165602558775 +1.2197 0.6985764721346085 0.6985744814509756 -3.906160409433701e-07 -0.09520307871095791 +1.2198 0.6985790133024059 0.6985770301817377 -3.9827394183317155e-07 -0.095204500984872 +1.2199 0.6985815536445729 0.6985795782475195 -4.058496647779686e-07 -0.09520592284744286 +1.22 0.6985840931622112 0.6985821256476399 -4.1334152505595467e-07 -0.09520734429878332 +1.2201000000000002 0.6985866318564398 0.6985846723813993 -4.207478572285095e-07 -0.09520876533900616 +1.2202 0.698589169728395 0.6985872184480812 -4.280670155426547e-07 -0.09521018596822416 +1.2203 0.6985917067792309 0.698589763846952 -4.352973743473876e-07 -0.0952116061865501 +1.2204000000000002 0.6985942430101176 0.6985923085772605 -4.4243732836429794e-07 -0.09521302599409665 +1.2205 0.6985967784222429 0.6985948526382388 -4.4948529309696283e-07 -0.09521444539097651 +1.2206000000000001 0.6985993130168104 0.6985973960291025 -4.5643970517789123e-07 -0.0952158643773024 +1.2207000000000001 0.6986018467950401 0.6985999387490505 -4.6329902272240764e-07 -0.09521728295318682 +1.2207999999999999 0.6986043797581687 0.6986024807972657 -4.700617256339634e-07 -0.09521870111874245 +1.2209 0.6986069119074478 0.6986050221729155 -4.7672631599271487e-07 -0.0952201188740819 +1.221 0.6986094432441461 0.6986075628751507 -4.832913183677734e-07 -0.09522153621931773 +1.2211 0.6986119737695458 0.6986101029031075 -4.897552801225169e-07 -0.09522295315456245 +1.2212 0.6986145034849451 0.6986126422559062 -4.961167717545956e-07 -0.09522436967992855 +1.2213 0.698617032391657 0.6986151809326524 -5.023743871873654e-07 -0.09522578579552843 +1.2214 0.6986195604910093 0.6986177189324374 -5.085267441515273e-07 -0.09522720150147464 +1.2215 0.6986220877843439 0.6986202562543372 -5.145724844418664e-07 -0.09522861679787953 +1.2216000000000002 0.6986246142730168 0.6986227928974146 -5.205102741739909e-07 -0.09523003168485555 +1.2217 0.698627139958398 0.6986253288607175 -5.2633880411046e-07 -0.09523144616251503 +1.2218 0.6986296648418706 0.6986278641432806 -5.3205679006324e-07 -0.09523286023097027 +1.2219 0.6986321889248317 0.6986303987441256 -5.376629729700322e-07 -0.09523427389033365 +1.222 0.6986347122086909 0.69863293266226 -5.43156119310606e-07 -0.0952356871407174 +1.2221000000000002 0.6986372346948706 0.6986354658966795 -5.485350213912943e-07 -0.09523709998223376 +1.2222 0.6986397563848061 0.6986379984463669 -5.537984974768317e-07 -0.09523851241499504 +1.2223 0.6986422772799443 0.6986405303102923 -5.589453922205667e-07 -0.09523992443911336 +1.2224000000000002 0.6986447973817442 0.6986430614874138 -5.639745767893611e-07 -0.0952413360547009 +1.2225 0.6986473166916767 0.6986455919766787 -5.68884949161963e-07 -0.09524274726186983 +1.2226000000000001 0.6986498352112238 0.6986481217770221 -5.736754343788064e-07 -0.09524415806073228 +1.2227000000000001 0.6986523529418784 0.6986506508873676 -5.783449847224231e-07 -0.09524556845140028 +1.2227999999999999 0.6986548698851447 0.6986531793066286 -5.828925800921425e-07 -0.09524697843398594 +1.2229 0.6986573860425369 0.6986557070337078 -5.873172280179695e-07 -0.09524838800860135 +1.223 0.6986599014155791 0.6986582340674972 -5.916179639936514e-07 -0.09524979717535836 +1.2231 0.698662416005806 0.6986607604068795 -5.957938517681116e-07 -0.09525120593436906 +1.2232 0.6986649298147614 0.6986632860507274 -5.99843983373205e-07 -0.09525261428574541 +1.2233 0.6986674428439986 0.6986658109979038 -6.037674794151515e-07 -0.0952540222295993 +1.2234 0.6986699550950797 0.6986683352472632 -6.075634892688253e-07 -0.09525542976604268 +1.2235 0.6986724665695753 0.6986708587976509 -6.112311912720436e-07 -0.09525683689518731 +1.2236000000000002 0.6986749772690648 0.6986733816479043 -6.147697928088336e-07 -0.09525824361714516 +1.2237 0.6986774871951351 0.6986759037968521 -6.181785306702547e-07 -0.09525964993202801 +1.2238 0.6986799963493815 0.6986784252433154 -6.214566710266434e-07 -0.09526105583994769 +1.2239 0.698682504733406 0.6986809459861074 -6.246035096357794e-07 -0.09526246134101586 +1.224 0.6986850123488177 0.6986834660240351 -6.276183720649309e-07 -0.09526386643534436 +1.2241000000000002 0.6986875191972333 0.6986859853558974 -6.305006138296321e-07 -0.09526527112304485 +1.2242 0.6986900252802748 0.6986885039804875 -6.332496203798055e-07 -0.095266675404229 +1.2243 0.6986925305995713 0.6986910218965923 -6.358648074605844e-07 -0.09526807927900852 +1.2244000000000002 0.6986950351567571 0.698693539102992 -6.383456210429239e-07 -0.095269482747495 +1.2245 0.6986975389534724 0.6986960555984623 -6.406915375456457e-07 -0.0952708858098 +1.2246000000000001 0.6987000419913622 0.6986985713817726 -6.429020638909488e-07 -0.09527228846603514 +1.2247000000000001 0.6987025442720767 0.6987010864516885 -6.449767376154325e-07 -0.09527369071631203 +1.2247999999999999 0.6987050457972701 0.6987036008069698 -6.469151271060181e-07 -0.09527509256074204 +1.2249 0.6987075465686015 0.6987061144463729 -6.487168314611713e-07 -0.09527649399943681 +1.225 0.6987100465877332 0.6987086273686497 -6.503814806851915e-07 -0.09527789503250778 +1.2251 0.6987125458563314 0.6987111395725487 -6.519087357576003e-07 -0.09527929566006631 +1.2252 0.698715044376065 0.6987136510568152 -6.532982888413086e-07 -0.09528069588222382 +1.2253 0.6987175421486065 0.6987161618201914 -6.54549862977305e-07 -0.0952820956990918 +1.2254 0.6987200391756305 0.6987186718614167 -6.556632125148676e-07 -0.0952834951107815 +1.2255 0.6987225354588138 0.6987211811792283 -6.566381230144192e-07 -0.09528489411740428 +1.2256000000000002 0.6987250309998354 0.6987236897723617 -6.574744111920161e-07 -0.09528629271907152 +1.2257 0.6987275258003753 0.6987261976395504 -6.581719251969043e-07 -0.0952876909158944 +1.2258 0.6987300198621149 0.6987287047795263 -6.587305443617186e-07 -0.09528908870798415 +1.2259 0.6987325131867368 0.6987312111910213 -6.591501793967725e-07 -0.09529048609545207 +1.226 0.6987350057759241 0.6987337168727659 -6.594307723623016e-07 -0.09529188307840936 +1.2261000000000002 0.6987374976313595 0.6987362218234902 -6.595722966268314e-07 -0.09529327965696713 +1.2262 0.6987399887547262 0.6987387260419247 -6.595747569504429e-07 -0.09529467583123655 +1.2263 0.6987424791477066 0.6987412295268003 -6.594381894292622e-07 -0.09529607160132873 +1.2264000000000002 0.6987449688119828 0.6987437322768484 -6.591626614121937e-07 -0.09529746696735479 +1.2265 0.6987474577492352 0.6987462342908011 -6.587482716396975e-07 -0.09529886192942577 +1.2266000000000001 0.6987499459611426 0.6987487355673925 -6.581951500911343e-07 -0.09530025648765267 +1.2267000000000001 0.698752433449383 0.6987512361053578 -6.575034579292538e-07 -0.09530165064214653 +1.2268 0.6987549202156311 0.6987537359034344 -6.566733875557063e-07 -0.09530304439301829 +1.2269 0.6987574062615604 0.6987562349603622 -6.557051624861421e-07 -0.09530443774037896 +1.227 0.6987598915888402 0.6987587332748837 -6.545990373363342e-07 -0.0953058306843394 +1.2271 0.698762376199138 0.6987612308457445 -6.533552976556445e-07 -0.09530722322501059 +1.2272 0.6987648600941171 0.6987637276716928 -6.519742600658018e-07 -0.09530861536250332 +1.2273 0.6987673432754373 0.6987662237514817 -6.504562719833462e-07 -0.0953100070969285 +1.2274 0.6987698257447543 0.6987687190838673 -6.488017115641176e-07 -0.09531139842839692 +1.2275 0.6987723075037192 0.6987712136676104 -6.470109876893781e-07 -0.09531278935701935 +1.2276000000000002 0.6987747885539786 0.6987737075014763 -6.45084539785401e-07 -0.0953141798829066 +1.2277 0.6987772688971738 0.6987762005842353 -6.430228378095926e-07 -0.09531557000616936 +1.2278 0.6987797485349412 0.6987786929146629 -6.408263820562032e-07 -0.09531695972691834 +1.2279 0.6987822274689109 0.6987811844915406 -6.384957030730609e-07 -0.09531834904526429 +1.228 0.698784705700707 0.6987836753136554 -6.360313614672819e-07 -0.09531973796131779 +1.2281000000000002 0.698787183231948 0.6987861653798002 -6.334339479330264e-07 -0.09532112647518948 +1.2282 0.6987896600642449 0.6987886546887755 -6.307040828906763e-07 -0.09532251458698998 +1.2283 0.6987921361992021 0.6987911432393876 -6.278424164729568e-07 -0.09532390229682988 +1.2284000000000002 0.6987946116384167 0.6987936310304508 -6.248496284416705e-07 -0.09532528960481969 +1.2285 0.6987970863834781 0.6987961180607863 -6.217264278685075e-07 -0.09532667651106996 +1.2286000000000001 0.698799560435968 0.6987986043292236 -6.184735530795349e-07 -0.09532806301569118 +1.2287000000000001 0.6988020337974594 0.6988010898345998 -6.150917713498849e-07 -0.09532944911879376 +1.2288000000000001 0.6988045064695172 0.6988035745757608 -6.115818788759997e-07 -0.09533083482048824 +1.2289 0.6988069784536979 0.698806058551561 -6.079447005397087e-07 -0.09533222012088499 +1.229 0.6988094497515478 0.698808541760864 -6.041810897416955e-07 -0.09533360502009439 +1.2291 0.6988119203646044 0.6988110242025427 -6.002919280267971e-07 -0.09533498951822679 +1.2292 0.6988143902943953 0.6988135058754795 -5.962781250840044e-07 -0.0953363736153925 +1.2293000000000003 0.6988168595424383 0.6988159867785668 -5.921406184827838e-07 -0.0953377573117019 +1.2294 0.6988193281102408 0.6988184669107074 -5.878803733955218e-07 -0.09533914060726521 +1.2295 0.6988217959992995 0.6988209462708138 -5.834983824448692e-07 -0.0953405235021927 +1.2296 0.6988242632110999 0.6988234248578107 -5.78995665440063e-07 -0.09534190599659459 +1.2297 0.6988267297471171 0.6988259026706325 -5.74373269154882e-07 -0.09534328809058111 +1.2298000000000002 0.698829195608814 0.698828379708226 -5.696322670223353e-07 -0.09534466978426237 +1.2299 0.6988316607976419 0.6988308559695489 -5.64773758968129e-07 -0.09534605107774856 +1.23 0.6988341253150407 0.698833331453571 -5.59798871091477e-07 -0.09534743197114981 +1.2301000000000002 0.6988365891624374 0.6988358061592744 -5.547087554985675e-07 -0.09534881246457616 +1.2302 0.698839052341246 0.6988382800856541 -5.49504589913985e-07 -0.0953501925581377 +1.2303000000000002 0.6988415148528685 0.698840753231717 -5.441875774725435e-07 -0.0953515722519445 +1.2304000000000002 0.6988439766986936 0.6988432255964834 -5.38758946497242e-07 -0.09535295154610651 +1.2305 0.698846437880096 0.6988456971789871 -5.332199501176249e-07 -0.09535433044073371 +1.2306000000000001 0.6988488983984378 0.698848167978275 -5.275718659644713e-07 -0.0953557089359361 +1.2307000000000001 0.6988513582550664 0.6988506379934083 -5.218159960032609e-07 -0.09535708703182362 +1.2308000000000001 0.6988538174513154 0.6988531072234616 -5.159536661733521e-07 -0.09535846472850612 +1.2309 0.6988562759885038 0.6988555756675243 -5.09986226041037e-07 -0.09535984202609349 +1.231 0.698858733867936 0.6988580433247003 -5.039150484595356e-07 -0.0953612189246956 +1.2311 0.698861191090902 0.6988605101941079 -4.977415294787901e-07 -0.09536259542442231 +1.2312 0.6988636476586758 0.6988629762748808 -4.914670876723926e-07 -0.09536397152538334 +1.2313000000000003 0.6988661035725167 0.6988654415661677 -4.850931641306455e-07 -0.09536534722768848 +1.2314 0.698868558833668 0.6988679060671332 -4.78621221960962e-07 -0.09536672253144751 +1.2315 0.6988710134433576 0.6988703697769572 -4.720527459686763e-07 -0.09536809743677009 +1.2316 0.6988734674027969 0.6988728326948357 -4.65389242386427e-07 -0.09536947194376594 +1.2317 0.6988759207131812 0.6988752948199811 -4.5863223843006784e-07 -0.09537084605254471 +1.2318000000000002 0.6988783733756893 0.6988777561516217 -4.5178328202805096e-07 -0.09537221976321604 +1.2319 0.6988808253914833 0.6988802166890031 -4.4484394146060424e-07 -0.09537359307588955 +1.232 0.6988832767617085 0.6988826764313869 -4.3781580497115336e-07 -0.09537496599067483 +1.2321000000000002 0.6988857274874926 0.6988851353780526 -4.3070048039856035e-07 -0.0953763385076814 +1.2322 0.6988881775699463 0.698887593528296 -4.2349959483017896e-07 -0.09537771062701876 +1.2323000000000002 0.6988906270101629 0.6988900508814313 -4.1621479423409324e-07 -0.09537908234879651 +1.2324000000000002 0.6988930758092178 0.6988925074367895 -4.0884774304278393e-07 -0.09538045367312403 +1.2325 0.6988955239681682 0.69889496319372 -4.014001238478171e-07 -0.09538182460011078 +1.2326000000000001 0.6988979714880538 0.6988974181515902 -3.9387363693493826e-07 -0.09538319512986625 +1.2327000000000001 0.6989004183698954 0.6988998723097852 -3.862699999857e-07 -0.0953845652624998 +1.2328000000000001 0.6989028646146953 0.698902325667709 -3.7859094760561707e-07 -0.09538593499812074 +1.2329 0.6989053102234375 0.6989047782247839 -3.7083823089395507e-07 -0.09538730433683845 +1.233 0.6989077551970874 0.698907229980451 -3.630136172286247e-07 -0.09538867327876228 +1.2331 0.6989101995365908 0.6989096809341699 -3.5511888963474236e-07 -0.09539004182400147 +1.2332 0.6989126432428747 0.69891213108542 -3.471558465695246e-07 -0.09539140997266535 +1.2333000000000003 0.6989150863168465 0.6989145804336996 -3.3912630136717636e-07 -0.09539277772486304 +1.2334 0.6989175287593943 0.698917028978526 -3.31032081926641e-07 -0.0953941450807038 +1.2335 0.6989199705713869 0.6989194767194364 -3.2287503026751097e-07 -0.09539551204029684 +1.2336 0.6989224117536725 0.6989219236559879 -3.146570020581829e-07 -0.0953968786037513 +1.2337 0.6989248523070803 0.6989243697877567 -3.0637986625503544e-07 -0.09539824477117628 +1.2338000000000002 0.6989272922324188 0.6989268151143394 -2.980455047207897e-07 -0.09539961054268088 +1.2339 0.698929731530477 0.6989292596353525 -2.8965581162776477e-07 -0.09540097591837424 +1.234 0.6989321702020227 0.6989317033504328 -2.8121269324971054e-07 -0.09540234089836527 +1.2341000000000002 0.6989346082478041 0.6989341462592378 -2.727180673511853e-07 -0.09540370548276317 +1.2342 0.6989370456685483 0.6989365883614445 -2.6417386280938593e-07 -0.09540506967167679 +1.2343000000000002 0.6989394824649621 0.6989390296567511 -2.555820191978142e-07 -0.09540643346521516 +1.2344000000000002 0.6989419186377311 0.6989414701448768 -2.469444863491266e-07 -0.09540779686348719 +1.2345 0.6989443541875207 0.6989439098255606 -2.3826322390757548e-07 -0.09540915986660181 +1.2346000000000001 0.6989467891149745 0.6989463486985632 -2.2954020083634785e-07 -0.09541052247466789 +1.2347000000000001 0.6989492234207159 0.6989487867636659 -2.207773950151093e-07 -0.09541188468779432 +1.2348000000000001 0.6989516571053467 0.6989512240206708 -2.1197679278897597e-07 -0.09541324650608993 +1.2349 0.6989540901694473 0.6989536604694018 -2.0314038854871153e-07 -0.0954146079296635 +1.235 0.6989565226135772 0.6989560961097034 -1.9427018420337117e-07 -0.09541596895862385 +1.2351 0.6989589544382739 0.6989585309414417 -1.8536818877090688e-07 -0.09541732959307966 +1.2352 0.6989613856440544 0.6989609649645039 -1.7643641794795606e-07 -0.09541868983313975 +1.2353000000000003 0.6989638162314131 0.6989633981787992 -1.6747689359983275e-07 -0.09542004967891277 +1.2354 0.6989662462008235 0.6989658305842575 -1.5849164335460242e-07 -0.09542140913050737 +1.2355 0.6989686755527373 0.6989682621808309 -1.4948270008960374e-07 -0.09542276818803225 +1.2356 0.6989711042875844 0.6989706929684927 -1.4045210153593168e-07 -0.09542412685159601 +1.2357 0.6989735324057731 0.6989731229472378 -1.3140188975108158e-07 -0.09542548512130725 +1.2358000000000002 0.6989759599076896 0.6989755521170831 -1.2233411071128908e-07 -0.09542684299727447 +1.2359 0.6989783867936987 0.6989779804780671 -1.1325081381539925e-07 -0.09542820047960633 +1.236 0.698980813064143 0.6989804080302497 -1.0415405144424683e-07 -0.0954295575684112 +1.2361000000000002 0.6989832387193438 0.6989828347737133 -9.504587847840307e-08 -0.0954309142637977 +1.2362 0.6989856637595997 0.6989852607085614 -8.592835184714764e-08 -0.09543227056587424 +1.2363000000000002 0.6989880881851881 0.6989876858349194 -7.68035300583586e-08 -0.09543362647474928 +1.2364000000000002 0.698990511996364 0.6989901101529349 -6.767347273534119e-08 -0.09543498199053116 +1.2365 0.6989929351933606 0.6989925336627771 -5.8540240153656664e-08 -0.09543633711332834 +1.2366000000000001 0.6989953577763892 0.6989949563646372 -4.9405892772746984e-08 -0.0954376918432491 +1.2367000000000001 0.698997779745639 0.6989973782587278 -4.027249077184205e-08 -0.09543904618040183 +1.2368000000000001 0.6990002011012777 0.6989997993452834 -3.1142093587710126e-08 -0.09544040012489478 +1.2369 0.6990026218434506 0.6990022196245611 -2.2016759447691936e-08 -0.09544175367683629 +1.237 0.6990050419722813 0.6990046390968387 -1.2898544908806348e-08 -0.0954431068363345 +1.2371 0.6990074614878719 0.6990070577624163 -3.789504392573417e-09 -0.0954444596034977 +1.2372 0.6990098803903019 0.699009475621616 5.308310278319406e-09 -0.0954458119784341 +1.2373000000000003 0.6990122986796297 0.699011892674781 1.4392850340369523e-08 -0.09544716396125187 +1.2374 0.6990147163558913 0.6990143089222767 2.3462070554598757e-08 -0.09544851555205913 +1.2375 0.6990171334191018 0.6990167243644897 3.251392965801514e-08 -0.09544986675096401 +1.2376 0.6990195498692535 0.6990191390018282 4.1546390832855606e-08 -0.09545121755807454 +1.2377 0.6990219657063185 0.6990215528347224 5.055742216021619e-08 -0.09545256797349888 +1.2378000000000002 0.6990243809302459 0.6990239658636235 5.954499708582528e-08 -0.095453917997345 +1.2379 0.699026795540964 0.6990263780890044 6.850709484591821e-08 -0.09545526762972094 +1.238 0.6990292095383797 0.6990287895113589 7.744170097030711e-08 -0.09545661687073465 +1.2381000000000002 0.6990316229223781 0.6990312001312027 8.634680770044922e-08 -0.0954579657204941 +1.2382 0.6990340356928237 0.6990336099490723 9.522041442833196e-08 -0.09545931417910726 +1.2383000000000002 0.6990364478495593 0.6990360189655248 1.0406052819433853e-07 -0.09546066224668194 +1.2384000000000002 0.6990388593924066 0.6990384271811398 1.1286516408276492e-07 -0.09546200992332615 +1.2385 0.6990412703211661 0.6990408345965162 1.216323457196855e-07 -0.09546335720914761 +1.2386000000000001 0.699043680635618 0.6990432412122751 1.3036010565459222e-07 -0.09546470410425423 +1.2387000000000001 0.6990460903355207 0.6990456470290569 1.390464858599949e-07 -0.09546605060875374 +1.2388000000000001 0.6990484994206132 0.6990480520475241 1.476895381338772e-07 -0.095467396722754 +1.2389000000000001 0.6990509078906123 0.6990504562683586 1.5628732456460237e-07 -0.0954687424463627 +1.239 0.6990533157452153 0.6990528596922634 1.648379179403081e-07 -0.09547008777968752 +1.2391 0.699055722984099 0.6990552623199615 1.7333940216870958e-07 -0.09547143272283622 +1.2392 0.6990581296069196 0.6990576641521961 1.8178987278016923e-07 -0.09547277727591642 +1.2393000000000003 0.6990605356133136 0.6990600651897306 1.9018743723647757e-07 -0.0954741214390358 +1.2394 0.699062941002897 0.6990624654333479 1.985302154686175e-07 -0.09547546521230191 +1.2395 0.6990653457752662 0.6990648648838512 2.068163402341172e-07 -0.09547680859582242 +1.2396 0.6990677499299979 0.6990672635420632 2.1504395757154793e-07 -0.09547815158970484 +1.2397 0.699070153466649 0.6990696614088254 2.2321122716828512e-07 -0.09547949419405669 +1.2398000000000002 0.6990725563847574 0.6990720584849996 2.313163228045978e-07 -0.09548083640898551 +1.2399 0.699074958683841 0.6990744547714662 2.3935743275610433e-07 -0.09548217823459876 +1.24 0.6990773603633992 0.6990768502691251 2.473327601962283e-07 -0.09548351967100388 +1.2401000000000002 0.6990797614229123 0.6990792449788944 2.552405236333488e-07 -0.09548486071830833 +1.2402 0.6990821618618415 0.6990816389017113 2.6307895722305075e-07 -0.09548620137661948 +1.2403000000000002 0.6990845616796295 0.6990840320385316 2.7084631126772507e-07 -0.09548754164604473 +1.2404000000000002 0.6990869608757011 0.6990864243903293 2.7854085250106353e-07 -0.09548888152669142 +1.2405 0.6990893594494623 0.6990888159580968 2.8616086453214784e-07 -0.0954902210186669 +1.2406000000000001 0.6990917574003006 0.6990912067428439 2.937046483242334e-07 -0.09549156012207845 +1.2407000000000001 0.6990941547275864 0.6990935967455986 3.0117052233352704e-07 -0.09549289883703327 +1.2408000000000001 0.699096551430672 0.6990959859674066 3.0855682310593213e-07 -0.0954942371636387 +1.2409000000000001 0.6990989475088926 0.6990983744093308 3.1586190555460414e-07 -0.09549557510200189 +1.241 0.6991013429615652 0.6991007620724514 3.2308414335546765e-07 -0.09549691265223005 +1.2411 0.6991037377879907 0.6991031489578656 3.302219292525277e-07 -0.09549824981443036 +1.2412 0.6991061319874524 0.6991055350666873 3.372736754880812e-07 -0.09549958658870994 +1.2413000000000003 0.6991085255592173 0.6991079204000473 3.4423781408027265e-07 -0.09550092297517594 +1.2414 0.6991109185025357 0.6991103049590924 3.5111279727412237e-07 -0.09550225897393538 +1.2415 0.6991133108166413 0.6991126887449858 3.578970978190821e-07 -0.09550359458509533 +1.2416 0.6991157025007526 0.6991150717589065 3.645892092396519e-07 -0.09550492980876289 +1.2417 0.699118093554072 0.6991174540020493 3.7118764636273616e-07 -0.09550626464504497 +1.2418000000000002 0.6991204839757857 0.6991198354756243 3.7769094544254367e-07 -0.0955075990940486 +1.2419 0.6991228737650653 0.6991222161808572 3.840976645838601e-07 -0.09550893315588074 +1.242 0.699125262921067 0.6991245961189883 3.90406384130626e-07 -0.09551026683064828 +1.2421000000000002 0.6991276514429319 0.6991269752912728 3.9661570679083713e-07 -0.09551160011845813 +1.2422 0.6991300393297872 0.6991293536989809 4.0272425812226675e-07 -0.09551293301941724 +1.2423000000000002 0.6991324265807446 0.6991317313433963 4.08730686782266e-07 -0.09551426553363236 +1.2424000000000002 0.6991348131949024 0.6991341082258173 4.1463366476368613e-07 -0.09551559766121032 +1.2425 0.6991371991713451 0.6991364843475559 4.2043188776264007e-07 -0.09551692940225798 +1.2426000000000001 0.699139584509143 0.6991388597099376 4.261240754768747e-07 -0.09551826075688208 +1.2427000000000001 0.6991419692073536 0.6991412343143006 4.3170897182781554e-07 -0.09551959172518928 +1.2428000000000001 0.699144353265021 0.6991436081619975 4.3718534526587804e-07 -0.09552092230728643 +1.2429000000000001 0.6991467366811767 0.6991459812543921 4.4255198907577897e-07 -0.0955222525032802 +1.243 0.6991491194548388 0.6991483535928615 4.478077215708254e-07 -0.09552358231327712 +1.2431 0.6991515015850142 0.6991507251787952 4.5295138639128707e-07 -0.095524911737384 +1.2432 0.6991538830706968 0.6991530960135939 4.5798185280970793e-07 -0.09552624077570733 +1.2433 0.6991562639108693 0.6991554660986705 4.628980159182561e-07 -0.09552756942835372 +1.2434 0.699158644104503 0.6991578354354497 4.6769879681607396e-07 -0.09552889769542977 +1.2435 0.6991610236505574 0.6991602040253662 4.7238314296316197e-07 -0.09553022557704198 +1.2436 0.6991634025479818 0.6991625718698662 4.769500283885453e-07 -0.09553155307329686 +1.2437 0.6991657807957141 0.6991649389704065 4.813984538637461e-07 -0.0955328801843009 +1.2438000000000002 0.6991681583926825 0.6991673053284544 4.857274471248285e-07 -0.09553420691016057 +1.2439 0.6991705353378047 0.699169670945486 4.899360631499539e-07 -0.09553553325098221 +1.244 0.6991729116299886 0.6991720358229883 4.9402338422877e-07 -0.0955368592068723 +1.2441000000000002 0.699175287268133 0.6991743999624573 4.979885203787449e-07 -0.09553818477793721 +1.2442 0.6991776622511272 0.6991767633653982 5.018306093451663e-07 -0.0955395099642833 +1.2443000000000002 0.6991800365778515 0.6991791260333244 5.055488169064537e-07 -0.09554083476601682 +1.2444000000000002 0.699182410247178 0.6991814879677585 5.091423369990578e-07 -0.09554215918324414 +1.2445 0.6991847832579705 0.699183849170231 5.126103917868496e-07 -0.09554348321607152 +1.2446000000000002 0.6991871556090841 0.6991862096422802 5.159522320913323e-07 -0.09554480686460515 +1.2447000000000001 0.6991895272993669 0.6991885693854523 5.191671374055185e-07 -0.0955461301289513 +1.2448000000000001 0.6991918983276597 0.6991909284013005 5.22254415907808e-07 -0.09554745300921615 +1.2449000000000001 0.6991942686927956 0.6991932866913848 5.252134048921997e-07 -0.09554877550550588 +1.245 0.6991966383936015 0.6991956442572724 5.280434707405357e-07 -0.09555009761792659 +1.2451 0.6991990074288974 0.6991980011005363 5.307440090612792e-07 -0.09555141934658434 +1.2452 0.6992013757974977 0.699200357222756 5.333144448144145e-07 -0.0955527406915854 +1.2453 0.6992037434982106 0.6992027126255165 5.357542325473696e-07 -0.09555406165303566 +1.2454 0.6992061105298388 0.6992050673104079 5.380628563811385e-07 -0.09555538223104122 +1.2455 0.6992084768911802 0.699207421279026 5.402398302045697e-07 -0.09555670242570811 +1.2456 0.6992108425810271 0.6992097745329712 5.422846976604889e-07 -0.09555802223714228 +1.2457 0.6992132075981677 0.6992121270738479 5.441970324371326e-07 -0.0955593416654497 +1.2458000000000002 0.6992155719413862 0.6992144789032652 5.459764381710031e-07 -0.09556066071073628 +1.2459 0.6992179356094621 0.6992168300228354 5.476225485301356e-07 -0.09556197937310791 +1.246 0.699220298601172 0.6992191804341752 5.491350275055318e-07 -0.09556329765267048 +1.2461000000000002 0.6992226609152891 0.6992215301389038 5.505135692029928e-07 -0.09556461554952984 +1.2462 0.6992250225505834 0.6992238791386434 5.517578981067972e-07 -0.09556593306379188 +1.2463000000000002 0.6992273835058225 0.6992262274350187 5.528677690658235e-07 -0.09556725019556234 +1.2464000000000002 0.6992297437797714 0.6992285750296567 5.538429672657941e-07 -0.09556856694494698 +1.2465 0.6992321033711937 0.6992309219241866 5.546833084096869e-07 -0.09556988331205157 +1.2466000000000002 0.6992344622788504 0.6992332681202382 5.553886386205908e-07 -0.09557119929698182 +1.2467000000000001 0.6992368205015019 0.6992356136194433 5.559588345804833e-07 -0.09557251489984339 +1.2468000000000001 0.6992391780379077 0.6992379584234347 5.56393803446964e-07 -0.09557383012074201 +1.2469000000000001 0.6992415348868259 0.6992403025338455 5.566934829920323e-07 -0.09557514495978334 +1.247 0.699243891047015 0.6992426459523091 5.568578414633096e-07 -0.09557645941707295 +1.2471 0.6992462465172328 0.6992449886804588 5.568868776534286e-07 -0.09557777349271643 +1.2472 0.6992486012962378 0.6992473307199274 5.567806209971771e-07 -0.09557908718681934 +1.2473 0.6992509553827886 0.6992496720723473 5.565391313494539e-07 -0.09558040049948718 +1.2474 0.6992533087756454 0.6992520127393496 5.561624991240466e-07 -0.09558171343082553 +1.2475 0.6992556614735694 0.6992543527225648 5.556508451132203e-07 -0.09558302598093989 +1.2476 0.6992580134753236 0.6992566920236202 5.550043207236399e-07 -0.09558433814993567 +1.2477 0.699260364779672 0.6992590306441426 5.542231076016702e-07 -0.09558564993791832 +1.2478000000000002 0.6992627153853819 0.6992613685857557 5.533074178276642e-07 -0.09558696134499324 +1.2479 0.6992650652912227 0.6992637058500806 5.522574937216751e-07 -0.09558827237126584 +1.248 0.6992674144959662 0.6992660424387356 5.510736079128442e-07 -0.0955895830168414 +1.2481000000000002 0.6992697629983885 0.6992683783533357 5.497560631451126e-07 -0.09559089328182535 +1.2482 0.6992721107972681 0.6992707135954923 5.483051922217097e-07 -0.09559220316632296 +1.2483000000000002 0.699274457891388 0.6992730481668127 5.467213580190311e-07 -0.09559351267043943 +1.2484000000000002 0.699276804279535 0.6992753820689002 5.450049533062273e-07 -0.09559482179428012 +1.2485 0.6992791499605004 0.6992777153033534 5.431564006203038e-07 -0.0955961305379502 +1.2486000000000002 0.6992814949330806 0.699280047871766 5.411761522799985e-07 -0.09559743890155485 +1.2487000000000001 0.6992838391960768 0.6992823797757266 5.390646901221041e-07 -0.09559874688519931 +1.2488000000000001 0.6992861827482957 0.6992847110168179 5.368225255986125e-07 -0.09560005448898867 +1.2489000000000001 0.6992885255885497 0.6992870415966175 5.344501994575257e-07 -0.0956013617130281 +1.249 0.699290867715657 0.6992893715166961 5.319482816734666e-07 -0.09560266855742262 +1.2491 0.6992932091284423 0.6992917007786188 5.293173713644128e-07 -0.09560397502227735 +1.2492 0.699295549825737 0.6992940293839435 5.265580965696515e-07 -0.09560528110769732 +1.2493 0.6992978898063795 0.6992963573342208 5.236711141387573e-07 -0.09560658681378754 +1.2494 0.6993002290692157 0.6992986846309943 5.206571095928147e-07 -0.09560789214065307 +1.2495 0.6993025676130982 0.6993010112757999 5.17516796971762e-07 -0.09560919708839878 +1.2496 0.6993049054368885 0.6993033372701656 5.142509185984689e-07 -0.0956105016571297 +1.2497 0.6993072425394553 0.6993056626156104 5.108602449399591e-07 -0.09561180584695067 +1.2498000000000002 0.6993095789196764 0.6993079873136463 5.073455744686317e-07 -0.0956131096579666 +1.2499 0.6993119145764379 0.6993103113657747 5.037077334263396e-07 -0.0956144130902823 +1.25 0.6993142495086355 0.6993126347734893 4.999475756300997e-07 -0.0956157161440027 +1.2501000000000002 0.6993165837151738 0.6993149575382737 4.960659822778046e-07 -0.09561701881923257 +1.2502 0.6993189171949672 0.6993172796616016 4.920638617678108e-07 -0.09561832111607671 +1.2503000000000002 0.6993212499469397 0.6993196011449369 4.879421494768943e-07 -0.09561962303463983 +1.2504000000000002 0.699323581970026 0.6993219219897333 4.837018075243282e-07 -0.09562092457502672 +1.2505 0.6993259132631706 0.6993242421974338 4.793438245359605e-07 -0.095622225737342 +1.2506000000000002 0.6993282438253297 0.6993265617694708 4.748692154915579e-07 -0.09562352652169043 +1.2507000000000001 0.6993305736554697 0.6993288807072651 4.7027902136398403e-07 -0.09562482692817663 +1.2508000000000001 0.6993329027525685 0.6993311990122264 4.6557430899429875e-07 -0.09562612695690523 +1.2509000000000001 0.699335231115616 0.6993335166857528 4.607561707586916e-07 -0.09562742660798083 +1.251 0.6993375587436134 0.6993358337292307 4.5582572438113145e-07 -0.09562872588150806 +1.2511 0.699339885635574 0.6993381501440334 4.5078411270438323e-07 -0.09563002477759142 +1.2512 0.6993422117905241 0.6993404659315225 4.4563250323204073e-07 -0.09563132329633542 +1.2513 0.699344537207502 0.6993427810930466 4.403720881146489e-07 -0.09563262143784462 +1.2514 0.699346861885559 0.6993450956299413 4.350040836847979e-07 -0.09563391920222342 +1.2515 0.6993491858237597 0.6993474095435288 4.295297303044676e-07 -0.09563521658957627 +1.2516 0.6993515090211824 0.6993497228351182 4.2395029200420487e-07 -0.09563651360000763 +1.2517 0.6993538314769182 0.6993520355060046 4.1826705617781235e-07 -0.09563781023362189 +1.2518000000000002 0.6993561531900727 0.6993543475574688 4.1248133331867054e-07 -0.09563910649052335 +1.2519 0.6993584741597659 0.6993566589907785 4.0659445677687645e-07 -0.09564040237081646 +1.252 0.6993607943851314 0.6993589698071856 4.0060778232903216e-07 -0.09564169787460551 +1.2521000000000002 0.699363113865318 0.6993612800079279 3.945226879353836e-07 -0.09564299300199475 +1.2522 0.6993654325994889 0.6993635895942278 3.883405734345091e-07 -0.09564428775308842 +1.2523000000000002 0.6993677505868232 0.6993658985672939 3.820628602033138e-07 -0.0956455821279909 +1.2524000000000002 0.6993700678265142 0.6993682069283178 3.756909908309014e-07 -0.0956468761268063 +1.2525 0.6993723843177715 0.6993705146784759 3.692264287716296e-07 -0.09564816974963881 +1.2526000000000002 0.6993747000598196 0.6993728218189292 3.626706580606154e-07 -0.09564946299659255 +1.2527000000000001 0.6993770150519001 0.6993751283508225 3.560251829043404e-07 -0.09565075586777175 +1.2528000000000001 0.6993793292932697 0.6993774342752843 3.49291527403095e-07 -0.09565204836328046 +1.2529000000000001 0.6993816427832025 0.6993797395934265 3.4247123513464484e-07 -0.09565334048322281 +1.253 0.6993839555209882 0.6993820443063443 3.3556586885585826e-07 -0.09565463222770282 +1.2531 0.6993862675059337 0.6993843484151164 3.2857701010718943e-07 -0.09565592359682454 +1.2532 0.6993885787373626 0.6993866519208043 3.2150625889348916e-07 -0.09565721459069199 +1.2533 0.6993908892146163 0.6993889548244515 3.1435523328154913e-07 -0.09565850520940909 +1.2534 0.6993931989370529 0.6993912571270853 3.0712556903927934e-07 -0.09565979545307984 +1.2535 0.6993955079040483 0.6993935588297144 2.998189192610079e-07 -0.09566108532180817 +1.2536 0.699397816114996 0.6993958599333303 2.924369539997196e-07 -0.09566237481569798 +1.2537 0.6994001235693075 0.6993981604389061 2.8498135988541673e-07 -0.09566366393485314 +1.2538000000000002 0.6994024302664122 0.699400460347397 2.7745383972960225e-07 -0.09566495267937751 +1.2539 0.6994047362057579 0.6994027596597397 2.698561121020071e-07 -0.0956662410493749 +1.254 0.6994070413868111 0.6994050583768527 2.621899110460957e-07 -0.0956675290449492 +1.2541000000000002 0.699409345809056 0.6994073564996357 2.544569855725265e-07 -0.09566881666620412 +1.2542 0.6994116494719961 0.699409654028969 2.4665909930526864e-07 -0.09567010391324338 +1.2543000000000002 0.6994139523751535 0.6994119509657151 2.38798030072207e-07 -0.09567139078617073 +1.2544000000000002 0.6994162545180695 0.6994142473107163 2.308755695165643e-07 -0.09567267728508987 +1.2545 0.6994185559003042 0.6994165430647963 2.2289352267362839e-07 -0.09567396341010438 +1.2546000000000002 0.6994208565214375 0.6994188382287594 2.1485370756829658e-07 -0.09567524916131803 +1.2547000000000001 0.6994231563810684 0.69942113280339 2.0675795479874193e-07 -0.0956765345388344 +1.2548000000000001 0.6994254554788155 0.6994234267894535 1.986081071062018e-07 -0.09567781954275709 +1.2549000000000001 0.6994277538143172 0.6994257201876948 1.9040601895864429e-07 -0.09567910417318964 +1.255 0.6994300513872311 0.6994280129988396 1.8215355617606788e-07 -0.09568038843023566 +1.2551 0.6994323481972357 0.6994303052235931 1.7385259542396225e-07 -0.09568167231399864 +1.2552 0.6994346442440285 0.6994325968626403 1.6550502386289412e-07 -0.09568295582458203 +1.2553 0.6994369395273278 0.6994348879166468 1.5711273865584574e-07 -0.09568423896208939 +1.2554 0.6994392340468717 0.6994371783862567 1.4867764660739247e-07 -0.09568552172662403 +1.2555 0.6994415278024191 0.6994394682720947 1.4020166366410236e-07 -0.09568680411828946 +1.2556 0.6994438207937484 0.6994417575747643 1.3168671450514147e-07 -0.09568808613718903 +1.2557 0.6994461130206596 0.6994440462948489 1.2313473211900128e-07 -0.09568936778342607 +1.2558000000000002 0.6994484044829727 0.6994463344329109 1.1454765736634842e-07 -0.095690649057104 +1.2559 0.6994506951805286 0.6994486219894922 1.0592743849777153e-07 -0.0956919299583261 +1.256 0.6994529851131885 0.6994509089651136 9.727603076173374e-08 -0.09569321048719569 +1.2561000000000002 0.6994552742808349 0.699453195360275 8.859539594313626e-08 -0.09569449064381591 +1.2562 0.6994575626833706 0.6994554811754554 7.988750189841243e-08 -0.0956957704282901 +1.2563000000000002 0.69945985032072 0.699457766411113 7.115432214960249e-08 -0.09569704984072144 +1.2564000000000002 0.6994621371928282 0.6994600510676847 6.23978354003657e-08 -0.09569832888121314 +1.2565 0.699464423299661 0.6994623351455864 5.3620025104034186e-08 -0.09569960754986832 +1.2566000000000002 0.6994667086412059 0.6994646186452123 4.482287901778903e-08 -0.09570088584679011 +1.2567000000000002 0.6994689932174707 0.699466901566936 3.600838874122381e-08 -0.09570216377208163 +1.2568000000000001 0.6994712770284854 0.6994691839111102 2.717854928613317e-08 -0.09570344132584603 +1.2569000000000001 0.6994735600743003 0.699471465678065 1.8335358595994444e-08 -0.09570471850818624 +1.257 0.6994758423549873 0.69947374686811 9.480817116623574e-09 -0.09570599531920537 +1.2571 0.6994781238706393 0.6994760274815338 6.169273338713088e-10 -0.09570727175900638 +1.2572 0.6994804046213711 0.6994783075186031 -8.254306671333367e-09 -0.0957085478276923 +1.2573 0.6994826846073179 0.6994805869795633 -1.71308796861544e-08 -0.09570982352536603 +1.2574 0.6994849638286367 0.6994828658646388 -2.601078581297364e-08 -0.09571109885213058 +1.2575 0.6994872422855054 0.699485144174032 -3.489201892172e-08 -0.09571237380808872 +1.2576 0.6994895199781236 0.6994874219079243 -4.377257310702329e-08 -0.09571364839334341 +1.2577 0.6994917969067119 0.6994896990664761 -5.2650443137128126e-08 -0.09571492260799752 +1.2578000000000003 0.6994940730715122 0.6994919756498259 -6.152362490969253e-08 -0.09571619645215385 +1.2579 0.6994963484727876 0.6994942516580912 -7.039011590314129e-08 -0.09571746992591522 +1.258 0.6994986231108222 0.6994965270913678 -7.924791562731459e-08 -0.09571874302938432 +1.2581000000000002 0.6995008969859219 0.6994988019497304 -8.809502607259878e-08 -0.09572001576266398 +1.2582 0.6995031700984133 0.6995010762332328 -9.692945217385646e-08 -0.09572128812585692 +1.2583000000000002 0.6995054424486438 0.6995033499419071 -1.057492022395537e-07 -0.09572256011906576 +1.2584000000000002 0.6995077140369828 0.6995056230757646 -1.1455228841536491e-07 -0.09572383174239327 +1.2585 0.6995099848638197 0.6995078956347948 -1.233367271247926e-07 -0.095725102995942 +1.2586000000000002 0.6995122549295656 0.699510167618967 -1.3210053952800171e-07 -0.09572637387981461 +1.2587000000000002 0.6995145242346524 0.6995124390282292 -1.4084175195029636e-07 -0.09572764439411376 +1.2588000000000001 0.6995167927795327 0.6995147098625083 -1.495583963392194e-07 -0.09572891453894199 +1.2589000000000001 0.6995190605646799 0.69951698012171 -1.5824851070517232e-07 -0.09573018431440178 +1.259 0.699521327590588 0.6995192498057201 -1.6691013955683065e-07 -0.0957314537205957 +1.2591 0.699523593857772 0.6995215189144025 -1.7554133434696806e-07 -0.09573272275762623 +1.2592 0.6995258593667673 0.6995237874476012 -1.8414015391307603e-07 -0.09573399142559585 +1.2593 0.6995281241181297 0.6995260554051393 -1.927046649127795e-07 -0.095735259724607 +1.2594 0.6995303881124356 0.6995283227868194 -2.0123294223323152e-07 -0.09573652765476204 +1.2595 0.6995326513502818 0.6995305895924238 -2.0972306948377484e-07 -0.0957377952161634 +1.2596 0.6995349138322845 0.6995328558217146 -2.181731393706421e-07 -0.09573906240891346 +1.2597 0.6995371755590813 0.6995351214744334 -2.2658125414104502e-07 -0.09574032923311455 +1.2598000000000003 0.6995394365313288 0.6995373865503018 -2.3494552601338592e-07 -0.09574159568886897 +1.2599 0.6995416967497041 0.6995396510490216 -2.4326407760746904e-07 -0.09574286177627904 +1.26 0.6995439562149035 0.6995419149702745 -2.5153504236083424e-07 -0.09574412749544699 +1.2601000000000002 0.6995462149276435 0.6995441783137224 -2.5975656492774335e-07 -0.09574539284647504 +1.2602 0.6995484728886598 0.6995464410790078 -2.679268016302083e-07 -0.09574665782946548 +1.2603000000000002 0.6995507300987076 0.6995487032657532 -2.7604392086044705e-07 -0.0957479224445204 +1.2604000000000002 0.6995529865585617 0.6995509648735625 -2.8410610347293086e-07 -0.09574918669174205 +1.2605 0.6995552422690157 0.69955322590202 -2.921115432007182e-07 -0.09575045057123255 +1.2606000000000002 0.6995574972308818 0.6995554863506903 -3.000584470960743e-07 -0.09575171408309395 +1.2607000000000002 0.6995597514449918 0.6995577462191199 -3.0794503586006883e-07 -0.09575297722742834 +1.2608000000000001 0.6995620049121958 0.6995600055068364 -3.1576954429013426e-07 -0.09575424000433785 +1.2609000000000001 0.6995642576333627 0.6995622642133481 -3.23530221682522e-07 -0.09575550241392441 +1.261 0.6995665096093794 0.6995645223381455 -3.312253322104719e-07 -0.09575676445629012 +1.2611 0.6995687608411514 0.6995667798807002 -3.388531552850349e-07 -0.0957580261315369 +1.2612 0.6995710113296022 0.6995690368404662 -3.464119859991621e-07 -0.09575928743976672 +1.2613 0.6995732610756731 0.6995712932168796 -3.5390013543301624e-07 -0.0957605483810816 +1.2614 0.6995755100803233 0.699573549009358 -3.613159311188774e-07 -0.09576180895558337 +1.2615 0.6995777583445288 0.6995758042173015 -3.686577173395156e-07 -0.09576306916337388 +1.2616 0.6995800058692838 0.6995780588400933 -3.7592385552370766e-07 -0.095764329004555 +1.2617 0.6995822526555995 0.699580312877099 -3.8311272466257096e-07 -0.0957655884792286 +1.2618000000000003 0.6995844987045039 0.6995825663276671 -3.9022272153160786e-07 -0.09576684758749647 +1.2619 0.6995867440170418 0.6995848191911292 -3.9725226125275626e-07 -0.09576810632946042 +1.262 0.6995889885942745 0.6995870714668002 -4.0419977746092295e-07 -0.09576936470522211 +1.2621000000000002 0.69959123243728 0.6995893231539786 -4.11063722741134e-07 -0.09577062271488335 +1.2622 0.6995934755471523 0.6995915742519467 -4.1784256898241834e-07 -0.09577188035854582 +1.2623000000000002 0.6995957179250012 0.6995938247599705 -4.2453480766924123e-07 -0.09577313763631118 +1.2624000000000002 0.6995979595719526 0.6995960746773005 -4.311389502839602e-07 -0.09577439454828113 +1.2625 0.6996002004891475 0.6995983240031711 -4.376535285496863e-07 -0.09577565109455725 +1.2626000000000002 0.6996024406777429 0.6996005727368015 -4.440770948604955e-07 -0.09577690727524117 +1.2627000000000002 0.69960468013891 0.6996028208773959 -4.504082224549011e-07 -0.09577816309043445 +1.2628000000000001 0.6996069188738356 0.6996050684241432 -4.566455059570873e-07 -0.09577941854023866 +1.2629000000000001 0.6996091568837208 0.6996073153762176 -4.627875614393595e-07 -0.09578067362475527 +1.263 0.6996113941697817 0.6996095617327791 -4.688330269495e-07 -0.09578192834408586 +1.2631000000000001 0.6996136307332473 0.6996118074929729 -4.747805626148516e-07 -0.09578318269833186 +1.2632 0.6996158665753618 0.6996140526559307 -4.80628851121101e-07 -0.09578443668759469 +1.2633 0.6996181016973824 0.6996162972207702 -4.863765978441181e-07 -0.09578569031197581 +1.2634 0.6996203361005803 0.6996185411865954 -4.920225312801674e-07 -0.09578694357157663 +1.2635 0.699622569786239 0.6996207845524972 -4.975654032055021e-07 -0.09578819646649851 +1.2636 0.6996248027556561 0.6996230273175533 -5.030039890441262e-07 -0.09578944899684277 +1.2637 0.6996270350101408 0.6996252694808287 -5.083370880412663e-07 -0.09579070116271075 +1.2638000000000003 0.6996292665510158 0.6996275110413759 -5.135635236797054e-07 -0.09579195296420376 +1.2639 0.6996314973796149 0.699629751998235 -5.186821437561107e-07 -0.09579320440142307 +1.264 0.6996337274972848 0.6996319923504344 -5.236918207904284e-07 -0.09579445547446994 +1.2641000000000002 0.6996359569053832 0.6996342320969902 -5.285914521993562e-07 -0.09579570618344557 +1.2642 0.6996381856052791 0.6996364712369073 -5.333799605322653e-07 -0.09579695652845113 +1.2643000000000002 0.6996404135983534 0.6996387097691796 -5.380562937279398e-07 -0.09579820650958781 +1.2644000000000002 0.699642640885997 0.6996409476927898 -5.426194253088656e-07 -0.0957994561269568 +1.2645 0.6996448674696119 0.6996431850067102 -5.470683547004196e-07 -0.09580070538065917 +1.2646000000000002 0.69964709335061 0.6996454217099022 -5.51402107390464e-07 -0.09580195427079606 +1.2647 0.6996493185304137 0.6996476578013175 -5.556197350820025e-07 -0.0958032027974685 +1.2648000000000001 0.6996515430104546 0.699649893279898 -5.597203160401243e-07 -0.09580445096077755 +1.2649000000000001 0.6996537667921741 0.6996521281445756 -5.637029551752715e-07 -0.09580569876082422 +1.265 0.6996559898770223 0.6996543623942734 -5.675667843069165e-07 -0.09580694619770946 +1.2651000000000001 0.699658212266459 0.6996565960279056 -5.713109622607071e-07 -0.09580819327153432 +1.2652 0.6996604339619521 0.6996588290443775 -5.749346752015327e-07 -0.09580943998239976 +1.2653 0.6996626549649774 0.6996610614425856 -5.784371366474028e-07 -0.09581068633040657 +1.2654 0.6996648752770191 0.6996632932214191 -5.8181758776088e-07 -0.09581193231565571 +1.2655 0.6996670948995694 0.6996655243797592 -5.850752974878581e-07 -0.09581317793824806 +1.2656 0.6996693138341272 0.6996677549164789 -5.882095625991957e-07 -0.09581442319828448 +1.2657 0.6996715320821996 0.699669984830445 -5.912197080654158e-07 -0.09581566809586578 +1.2658000000000003 0.6996737496452992 0.6996722141205167 -5.941050870428288e-07 -0.09581691263109272 +1.2659 0.6996759665249457 0.6996744427855468 -5.9686508101231e-07 -0.09581815680406608 +1.266 0.6996781827226652 0.6996766708243818 -5.994990999874661e-07 -0.0958194006148866 +1.2661000000000002 0.6996803982399896 0.6996788982358626 -6.020065825423915e-07 -0.09582064406365502 +1.2662 0.6996826130784561 0.6996811250188237 -6.043869960753456e-07 -0.09582188715047205 +1.2663000000000002 0.6996848272396075 0.6996833511720946 -6.0663983676712e-07 -0.09582312987543827 +1.2664000000000002 0.6996870407249913 0.6996855766944996 -6.087646297614491e-07 -0.09582437223865438 +1.2665 0.6996892535361598 0.6996878015848582 -6.107609293037886e-07 -0.09582561424022097 +1.2666000000000002 0.69969146567467 0.6996900258419858 -6.126283187690706e-07 -0.09582685588023863 +1.2667 0.6996936771420823 0.6996922494646933 -6.143664107310931e-07 -0.09582809715880794 +1.2668000000000001 0.6996958879399613 0.699694472451788 -6.159748471706861e-07 -0.09582933807602946 +1.2669000000000001 0.6996980980698747 0.6996966948020733 -6.174532993646897e-07 -0.09583057863200363 +1.267 0.6997003075333936 0.6996989165143499 -6.18801468107999e-07 -0.095831818826831 +1.2671000000000001 0.699702516332092 0.6997011375874154 -6.200190837135633e-07 -0.09583305866061204 +1.2672 0.6997047244675461 0.6997033580200642 -6.211059059846313e-07 -0.09583429813344717 +1.2673 0.699706931941334 0.6997055778110898 -6.220617244784288e-07 -0.0958355372454368 +1.2674 0.6997091387550365 0.6997077969592824 -6.22886358270236e-07 -0.0958367759966813 +1.2675 0.6997113449102352 0.6997100154634313 -6.235796562864548e-07 -0.0958380143872811 +1.2676 0.6997135504085129 0.6997122333223242 -6.241414969992976e-07 -0.09583925241733644 +1.2677 0.6997157552514539 0.6997144505347483 -6.245717887320978e-07 -0.09584049008694777 +1.2678000000000003 0.6997179594406429 0.6997166670994894 -6.248704695205332e-07 -0.09584172739621527 +1.2679 0.6997201629776642 0.6997188830153332 -6.250375071403802e-07 -0.09584296434523924 +1.268 0.6997223658641025 0.6997210982810655 -6.250728992046595e-07 -0.09584420093411987 +1.2681000000000002 0.6997245681015426 0.6997233128954724 -6.249766729693462e-07 -0.09584543716295744 +1.2682 0.6997267696915679 0.6997255268573404 -6.247488855137817e-07 -0.09584667303185208 +1.2683000000000002 0.6997289706357614 0.6997277401654567 -6.243896236018953e-07 -0.09584790854090401 +1.2684000000000002 0.6997311709357046 0.6997299528186101 -6.238990036405712e-07 -0.09584914369021333 +1.2685 0.699733370592977 0.6997321648155906 -6.23277171818426e-07 -0.09585037847988018 +1.2686000000000002 0.6997355696091567 0.6997343761551906 -6.225243037727424e-07 -0.09585161291000462 +1.2687 0.699737767985819 0.6997365868362041 -6.216406048392686e-07 -0.09585284698068673 +1.2688000000000001 0.6997399657245372 0.6997387968574278 -6.206263097469078e-07 -0.09585408069202653 +1.2689000000000001 0.6997421628268814 0.6997410062176608 -6.19481682839762e-07 -0.09585531404412402 +1.269 0.6997443592944182 0.6997432149157057 -6.182070177163101e-07 -0.09585654703707919 +1.2691000000000001 0.6997465551287114 0.6997454229503688 -6.168026372987967e-07 -0.09585777967099202 +1.2692 0.6997487503313204 0.6997476303204595 -6.15268893819354e-07 -0.09585901194596241 +1.2693 0.699750944903801 0.6997498370247917 -6.136061685840799e-07 -0.09586024386209036 +1.2694 0.6997531388477041 0.6997520430621831 -6.118148719591598e-07 -0.09586147541947565 +1.2695 0.699755332164576 0.6997542484314565 -6.098954433153558e-07 -0.09586270661821822 +1.2696 0.6997575248559582 0.6997564531314395 -6.078483507365728e-07 -0.09586393745841787 +1.2697 0.6997597169233865 0.6997586571609652 -6.056740911586367e-07 -0.09586516794017445 +1.2698000000000003 0.699761908368391 0.6997608605188718 -6.033731900917383e-07 -0.0958663980635877 +1.2699 0.6997640991924963 0.6997630632040035 -6.009462015232891e-07 -0.0958676278287574 +1.27 0.6997662893972201 0.6997652652152107 -5.98393707806899e-07 -0.09586885723578324 +1.2701000000000002 0.699768478984074 0.6997674665513505 -5.957163194819648e-07 -0.09587008628476495 +1.2702 0.6997706679545628 0.6997696672112865 -5.929146752181591e-07 -0.0958713149758023 +1.2703000000000002 0.6997728563101839 0.6997718671938896 -5.89989441523997e-07 -0.09587254330899486 +1.2704000000000002 0.6997750440524275 0.6997740664980379 -5.86941312677447e-07 -0.09587377128444233 +1.2705 0.6997772311827755 0.6997762651226168 -5.837710106287863e-07 -0.09587499890224425 +1.2706000000000002 0.6997794177027025 0.6997784630665203 -5.8047928469529e-07 -0.0958762261625003 +1.2707 0.6997816036136739 0.6997806603286503 -5.770669114224525e-07 -0.09587745306530994 +1.2708000000000002 0.6997837889171474 0.699782856907917 -5.73534694459088e-07 -0.09587867961077276 +1.2709000000000001 0.6997859736145713 0.6997850528032397 -5.698834643075301e-07 -0.09587990579898824 +1.271 0.6997881577073848 0.6997872480135467 -5.661140781570984e-07 -0.09588113163005586 +1.2711000000000001 0.6997903411970178 0.699789442537776 -5.622274197314425e-07 -0.09588235710407515 +1.2712 0.6997925240848901 0.6997916363748746 -5.582243988860869e-07 -0.09588358222114551 +1.2713 0.6997947063724117 0.6997938295237998 -5.541059517194524e-07 -0.09588480698136632 +1.2714 0.6997968880609824 0.6997960219835192 -5.498730399899898e-07 -0.09588603138483703 +1.2715 0.6997990691519911 0.6997982137530104 -5.45526651268835e-07 -0.09588725543165692 +1.2716 0.6998012496468164 0.6998004048312624 -5.41067798377759e-07 -0.09588847912192539 +1.2717 0.6998034295468252 0.6998025952172748 -5.364975193475341e-07 -0.09588970245574172 +1.2718000000000003 0.6998056088533733 0.6998047849100584 -5.318168771265008e-07 -0.09589092543320518 +1.2719 0.6998077875678053 0.6998069739086357 -5.270269593515842e-07 -0.0958921480544151 +1.272 0.699809965691453 0.699809162212041 -5.221288780291045e-07 -0.09589337031947066 +1.2721000000000002 0.6998121432256367 0.6998113498193206 -5.171237693127329e-07 -0.09589459222847108 +1.2722 0.699814320171664 0.6998135367295333 -5.120127932745078e-07 -0.09589581378151554 +1.2723000000000002 0.6998164965308302 0.69981572294175 -5.067971336203403e-07 -0.09589703497870321 +1.2724000000000002 0.6998186723044175 0.6998179084550551 -5.014779974124584e-07 -0.09589825582013327 +1.2725 0.6998208474936949 0.6998200932685452 -4.960566147779732e-07 -0.09589947630590477 +1.2726000000000002 0.6998230220999178 0.6998222773813307 -4.905342386105072e-07 -0.09590069643611678 +1.2727 0.6998251961243284 0.6998244607925356 -4.849121443550874e-07 -0.09590191621086842 +1.2728000000000002 0.6998273695681549 0.6998266435012973 -4.791916296334464e-07 -0.0959031356302587 +1.2729000000000001 0.6998295424326113 0.6998288255067677 -4.733740139734044e-07 -0.09590435469438667 +1.273 0.6998317147188975 0.6998310068081126 -4.6746063851049735e-07 -0.09590557340335126 +1.2731000000000001 0.6998338864281985 0.6998331874045121 -4.6145286566878774e-07 -0.09590679175725147 +1.2732 0.6998360575616848 0.6998353672951612 -4.5535207886249207e-07 -0.09590800975618623 +1.2733 0.6998382281205118 0.6998375464792701 -4.491596821767918e-07 -0.09590922740025444 +1.2734 0.6998403981058195 0.6998397249560633 -4.4287710000701086e-07 -0.09591044468955501 +1.2735 0.6998425675187329 0.6998419027247814 -4.3650577677412095e-07 -0.09591166162418674 +1.2736 0.6998447363603609 0.6998440797846803 -4.3004717663330805e-07 -0.09591287820424851 +1.2737 0.699846904631797 0.6998462561350314 -4.23502783043761e-07 -0.09591409442983911 +1.2738000000000003 0.6998490723341186 0.6998484317751225 -4.168740984356045e-07 -0.0959153103010574 +1.2739 0.6998512394683867 0.6998506067042569 -4.1016264397397695e-07 -0.09591652581800211 +1.274 0.6998534060356457 0.6998527809217551 -4.0336995907330753e-07 -0.09591774098077198 +1.2741000000000002 0.6998555720369238 0.6998549544269533 -3.964976011475163e-07 -0.09591895578946569 +1.2742 0.699857737473232 0.6998571272192051 -3.8954714515898603e-07 -0.09592017024418198 +1.2743000000000002 0.6998599023455645 0.6998592992978799 -3.825201833687619e-07 -0.09592138434501944 +1.2744000000000002 0.6998620666548983 0.6998614706623656 -3.754183249063403e-07 -0.09592259809207676 +1.2745 0.6998642304021931 0.6998636413120662 -3.68243195415785e-07 -0.09592381148545254 +1.2746000000000002 0.6998663935883912 0.6998658112464041 -3.609964366602103e-07 -0.0959250245252454 +1.2747 0.6998685562144169 0.6998679804648185 -3.536797061540198e-07 -0.09592623721155387 +1.2748000000000002 0.6998707182811768 0.6998701489667666 -3.462946768159614e-07 -0.0959274495444765 +1.2749000000000001 0.6998728797895597 0.6998723167517236 -3.388430365527939e-07 -0.09592866152411184 +1.275 0.6998750407404355 0.6998744838191827 -3.313264879400979e-07 -0.09592987315055829 +1.2751000000000001 0.6998772011346566 0.6998766501686555 -3.237467476949196e-07 -0.09593108442391442 +1.2752000000000001 0.6998793609730569 0.6998788157996715 -3.16105546425971e-07 -0.09593229534427856 +1.2753 0.6998815202564512 0.6998809807117792 -3.084046281826014e-07 -0.09593350591174923 +1.2754 0.699883678985636 0.6998831449045453 -3.0064575004540295e-07 -0.09593471612642475 +1.2755 0.6998858371613885 0.6998853083775558 -2.928306817237547e-07 -0.09593592598840353 +1.2756 0.6998879947844674 0.6998874711304152 -2.849612051950001e-07 -0.09593713549778388 +1.2757 0.6998901518556115 0.6998896331627473 -2.770391142603579e-07 -0.09593834465466411 +1.2758000000000003 0.6998923083755415 0.6998917944741949 -2.690662141251188e-07 -0.0959395534591426 +1.2759 0.6998944643449576 0.6998939550644201 -2.6104432103782327e-07 -0.09594076191131753 +1.276 0.6998966197645413 0.6998961149331044 -2.52975261828825e-07 -0.09594197001128717 +1.2761000000000002 0.6998987746349539 0.6998982740799488 -2.4486087351824337e-07 -0.09594317775914969 +1.2762 0.6999009289568374 0.6999004325046736 -2.367030028961603e-07 -0.09594438515500335 +1.2763000000000002 0.6999030827308141 0.6999025902070195 -2.2850350608200065e-07 -0.09594559219894631 +1.2764000000000002 0.6999052359574858 0.6999047471867461 -2.2026424812901513e-07 -0.09594679889107662 +1.2765 0.6999073886374352 0.6999069034436338 -2.1198710260100784e-07 -0.09594800523149251 +1.2766000000000002 0.6999095407712241 0.6999090589774827 -2.0367395113518594e-07 -0.09594921122029205 +1.2767 0.6999116923593949 0.6999112137881122 -1.9532668300153988e-07 -0.0959504168575733 +1.2768000000000002 0.6999138434024693 0.6999133678753626 -1.8694719468997922e-07 -0.09595162214343432 +1.2769000000000001 0.6999159939009485 0.6999155212390944 -1.78537389493999e-07 -0.09595282707797305 +1.277 0.6999181438553141 0.6999176738791878 -1.7009917703883493e-07 -0.09595403166128756 +1.2771000000000001 0.6999202932660264 0.6999198257955441 -1.6163447287900756e-07 -0.09595523589347582 +1.2772000000000001 0.6999224421335262 0.6999219769880844 -1.531451980767845e-07 -0.09595643977463579 +1.2773 0.6999245904582327 0.6999241274567505 -1.4463327870951892e-07 -0.09595764330486535 +1.2774 0.6999267382405454 0.6999262772015044 -1.36100645496684e-07 -0.0959588464842624 +1.2775 0.6999288854808425 0.6999284262223286 -1.2754923332108925e-07 -0.09596004931292479 +1.2776 0.6999310321794823 0.6999305745192272 -1.1898098080213859e-07 -0.09596125179095048 +1.2777 0.6999331783368012 0.6999327220922235 -1.1039782985694524e-07 -0.09596245391843715 +1.2778000000000003 0.6999353239531165 0.699934868941362 -1.0180172527705922e-07 -0.09596365569548267 +1.2779 0.6999374690287232 0.6999370150667081 -9.319461425402048e-08 -0.09596485712218479 +1.278 0.6999396135638963 0.6999391604683478 -8.457844596736208e-08 -0.09596605819864128 +1.2781000000000002 0.6999417575588899 0.6999413051463874 -7.595517112317374e-08 -0.09596725892494982 +1.2782 0.6999439010139374 0.6999434491009546 -6.73267415238904e-08 -0.09596845930120818 +1.2783000000000002 0.6999460439292512 0.6999455923321969 -5.869510963027458e-08 -0.09596965932751395 +1.2784 0.699948186305023 0.6999477348402834 -5.0062228108002996e-08 -0.09597085900396485 +1.2785 0.6999503281414234 0.6999498766254033 -4.143004939555781e-08 -0.09597205833065847 +1.2786000000000002 0.6999524694386026 0.6999520176877669 -3.280052525574638e-08 -0.09597325730769242 +1.2787 0.69995461019669 0.6999541580276052 -2.4175606341478306e-08 -0.0959744559351643 +1.2788000000000002 0.6999567504157937 0.6999562976451694 -1.5557241747447825e-08 -0.09597565421317161 +1.2789000000000001 0.6999588900960018 0.6999584365407319 -6.947378575206109e-09 -0.0959768521418119 +1.279 0.699961029237381 0.6999605747145856 1.652038505994824e-09 -0.09597804972118268 +1.2791000000000001 0.6999631678399774 0.6999627121670435 1.0239067704809202e-08 -0.09597924695138138 +1.2792000000000001 0.6999653059038169 0.69996484889844 1.881177053800892e-08 -0.0959804438325055 +1.2793 0.6999674434289048 0.6999669849091297 2.7368212274572756e-08 -0.09598164036465251 +1.2794 0.6999695804152253 0.6999691201994871 3.590646236936723e-08 -0.09598283654791975 +1.2795 0.6999717168627422 0.699971254769908 4.442459490029693e-08 -0.0959840323824046 +1.2796 0.699973852771399 0.6999733886208079 5.292068899938329e-08 -0.09598522786820445 +1.2797 0.6999759881411186 0.6999755217526231 6.139282928037393e-08 -0.09598642300541656 +1.2798000000000003 0.6999781229718038 0.69997765416581 6.983910630364853e-08 -0.0959876177941383 +1.2799 0.6999802572633371 0.6999797858608452 7.825761694571498e-08 -0.09598881223446697 +1.28 0.6999823910155805 0.6999819168382252 8.664646488840133e-08 -0.09599000632649977 +1.2801000000000002 0.6999845242283758 0.6999840470984667 9.500376101090335e-08 -0.09599120007033392 +1.2802 0.6999866569015454 0.6999861766421065 1.0332762382866956e-07 -0.09599239346606664 +1.2803000000000002 0.6999887890348913 0.6999883054697011 1.1161617991320427e-07 -0.09599358651379516 +1.2804 0.6999909206281953 0.6999904335818268 1.1986756430840129e-07 -0.09599477921361661 +1.2805 0.6999930516812203 0.6999925609790796 1.2807992097463305e-07 -0.09599597156562811 +1.2806000000000002 0.6999951821937085 0.6999946876620751 1.3625140315304263e-07 -0.09599716356992677 +1.2807 0.6999973121653831 0.6999968136314482 1.4438017383738844e-07 -0.09599835522660964 +1.2808000000000002 0.6999994415959478 0.6999989388878535 1.5246440617650014e-07 -0.09599954653577385 +1.2809000000000001 0.700001570485087 0.7000010634319648 1.605022838489789e-07 -0.09600073749751639 +1.281 0.7000036988324658 0.7000031872644749 1.6849200149687826e-07 -0.09600192811193432 +1.2811000000000001 0.70000582663773 0.7000053103860954 1.7643176514550718e-07 -0.09600311837912456 +1.2812000000000001 0.7000079539005064 0.7000074327975574 1.8431979259200815e-07 -0.0960043082991841 +1.2813 0.7000100806204035 0.7000095544996104 1.921543137627102e-07 -0.09600549787220994 +1.2814 0.7000122067970102 0.7000116754930223 1.999335712092598e-07 -0.09600668709829889 +1.2815 0.7000143324298973 0.7000137957785799 2.076558204243406e-07 -0.09600787597754785 +1.2816 0.7000164575186171 0.7000159153570882 2.1531933022678196e-07 -0.0960090645100537 +1.2817 0.7000185820627038 0.7000180342293707 2.2292238319870927e-07 -0.09601025269591333 +1.2818000000000003 0.7000207060616732 0.7000201523962681 2.304632760741221e-07 -0.09601144053522347 +1.2819 0.7000228295150231 0.7000222698586402 2.379403200442054e-07 -0.09601262802808098 +1.282 0.7000249524222337 0.7000243866173638 2.453518412187661e-07 -0.09601381517458263 +1.2821000000000002 0.700027074782767 0.7000265026733331 2.526961809523609e-07 -0.09601500197482513 +1.2822 0.7000291965960681 0.7000286180274602 2.5997169623981353e-07 -0.09601618842890515 +1.2823000000000002 0.7000313178615643 0.7000307326806743 2.6717676007009805e-07 -0.09601737453691946 +1.2824 0.7000334385786656 0.7000328466339216 2.743097617941004e-07 -0.09601856029896466 +1.2825 0.700035558746766 0.7000349598881652 2.8136910750625743e-07 -0.09601974571513744 +1.2826000000000002 0.7000376783652418 0.7000370724443851 2.883532203706851e-07 -0.09602093078553442 +1.2827 0.7000397974334528 0.7000391843035774 2.9526054097506194e-07 -0.09602211551025214 +1.2828000000000002 0.7000419159507425 0.700041295466755 3.020895276914515e-07 -0.09602329988938724 +1.2829000000000002 0.7000440339164382 0.7000434059349467 3.088386569954915e-07 -0.09602448392303625 +1.283 0.7000461513298512 0.7000455157091975 3.1550642387578876e-07 -0.0960256676112957 +1.2831000000000001 0.7000482681902767 0.7000476247905676 3.2209134209065793e-07 -0.09602685095426204 +1.2832000000000001 0.7000503844969943 0.7000497331801332 3.2859194453588314e-07 -0.09602803395203176 +1.2833 0.7000525002492686 0.7000518408789858 3.3500678352227364e-07 -0.09602921660470133 +1.2834 0.7000546154463486 0.7000539478882316 3.4133443123363083e-07 -0.09603039891236716 +1.2835 0.7000567300874683 0.7000560542089924 3.475734798863428e-07 -0.09603158087512564 +1.2836 0.7000588441718467 0.7000581598424043 3.537225421249013e-07 -0.09603276249307312 +1.2837 0.7000609576986888 0.7000602647896177 3.5978025129251856e-07 -0.09603394376630596 +1.2838000000000003 0.7000630706671851 0.7000623690517975 3.65745261785011e-07 -0.0960351246949205 +1.2839 0.7000651830765119 0.7000644726301231 3.716162493214159e-07 -0.09603630527901312 +1.284 0.7000672949258312 0.7000665755257864 3.7739191122154736e-07 -0.09603748551867997 +1.2841000000000002 0.7000694062142919 0.7000686777399938 3.8307096675294083e-07 -0.09603866541401733 +1.2842 0.7000715169410293 0.7000707792739651 3.8865215730432556e-07 -0.09603984496512141 +1.2843000000000002 0.700073627105166 0.7000728801289331 3.941342467742026e-07 -0.0960410241720886 +1.2844 0.7000757367058106 0.7000749803061428 3.9951602182064505e-07 -0.09604220303501486 +1.2845 0.7000778457420598 0.7000770798068524 4.0479629207640366e-07 -0.0960433815539964 +1.2846000000000002 0.7000799542129976 0.7000791786323324 4.099738905236072e-07 -0.09604455972912937 +1.2847 0.7000820621176959 0.7000812767838651 4.150476735631514e-07 -0.09604573756050988 +1.2848000000000002 0.7000841694552147 0.7000833742627453 4.200165214587881e-07 -0.096046915048234 +1.2849000000000002 0.7000862762246021 0.7000854710702787 4.248793384897809e-07 -0.09604809219239782 +1.285 0.7000883824248948 0.7000875672077824 4.296350532145832e-07 -0.0960492689930973 +1.2851000000000001 0.7000904880551188 0.7000896626765852 4.3428261869982165e-07 -0.09605044545042854 +1.2852000000000001 0.700092593114289 0.7000917574780259 4.3882101277009644e-07 -0.09605162156448749 +1.2853 0.7000946976014089 0.700093851613454 4.4324923818839235e-07 -0.09605279733537005 +1.2854 0.7000968015154728 0.7000959450842299 4.475663228781235e-07 -0.09605397276317225 +1.2855 0.7000989048554643 0.7000980378917234 4.5177132026313904e-07 -0.09605514784798996 +1.2856 0.7001010076203571 0.7001001300373138 4.558633092816011e-07 -0.09605632258991904 +1.2857 0.7001031098091155 0.7001022215223908 4.5984139469129603e-07 -0.09605749698905536 +1.2858000000000003 0.7001052114206944 0.7001043123483524 4.6370470732637337e-07 -0.0960586710454948 +1.2859 0.7001073124540399 0.7001064025166059 4.674524041042849e-07 -0.0960598447593331 +1.286 0.7001094129080895 0.7001084920285673 4.710836683519126e-07 -0.09606101813066613 +1.2861000000000002 0.700111512781772 0.7001105808856607 4.7459771004843e-07 -0.09606219115958964 +1.2862 0.700113612074008 0.7001126690893182 4.779937658044853e-07 -0.09606336384619935 +1.2863000000000002 0.7001157107837106 0.7001147566409802 4.812710991813907e-07 -0.09606453619059102 +1.2864 0.7001178089097848 0.7001168435420935 4.844290007327556e-07 -0.09606570819286026 +1.2865 0.700119906451129 0.700118929794113 4.874667882820427e-07 -0.09606687985310276 +1.2866000000000002 0.700122003406634 0.7001210153985005 4.903838069780786e-07 -0.0960680511714142 +1.2867 0.7001240997751845 0.7001231003567239 4.931794293366876e-07 -0.09606922214789025 +1.2868000000000002 0.700126195555658 0.7001251846702577 4.958530557541696e-07 -0.09607039278262641 +1.2869000000000002 0.7001282907469265 0.7001272683405826 4.984041142297446e-07 -0.09607156307571829 +1.287 0.7001303853478559 0.7001293513691844 5.00832060726375e-07 -0.09607273302726142 +1.2871000000000001 0.7001324793573067 0.7001314337575549 5.031363790874988e-07 -0.09607390263735131 +1.2872000000000001 0.7001345727741344 0.700133515507191 5.053165813978522e-07 -0.0960750719060835 +1.2873 0.7001366655971895 0.7001355966195941 5.073722078169363e-07 -0.09607624083355348 +1.2874 0.7001387578253171 0.7001376770962706 5.093028269120836e-07 -0.09607740941985665 +1.2875 0.7001408494573593 0.7001397569387302 5.111080356168252e-07 -0.09607857766508848 +1.2876 0.7001429404921533 0.7001418361484876 5.127874593419124e-07 -0.09607974556934434 +1.2877 0.7001450309285331 0.7001439147270604 5.143407520169507e-07 -0.09608091313271963 +1.2878000000000003 0.7001471207653285 0.7001459926759697 5.157675963124442e-07 -0.09608208035530966 +1.2879 0.7001492100013669 0.7001480699967398 5.170677034871396e-07 -0.09608324723720979 +1.288 0.7001512986354728 0.7001501466908975 5.182408135961936e-07 -0.09608441377851533 +1.2881000000000002 0.7001533866664683 0.7001522227599717 5.192866954911723e-07 -0.09608557997932153 +1.2882 0.7001554740931731 0.700154298205494 5.202051468616853e-07 -0.0960867458397237 +1.2883000000000002 0.7001575609144053 0.7001563730289975 5.209959942770181e-07 -0.096087911359817 +1.2884 0.700159647128981 0.7001584472320165 5.216590932277665e-07 -0.09608907653969671 +1.2885 0.7001617327357155 0.7001605208160872 5.221943281813468e-07 -0.09609024137945801 +1.2886000000000002 0.700163817733423 0.7001625937827454 5.22601612554241e-07 -0.09609140587919604 +1.2887 0.7001659021209168 0.7001646661335289 5.228808886842407e-07 -0.09609257003900595 +1.2888000000000002 0.7001679858970101 0.7001667378699745 5.230321279969807e-07 -0.0960937338589828 +1.2889000000000002 0.7001700690605162 0.7001688089936197 5.23055330770017e-07 -0.09609489733922168 +1.289 0.7001721516102487 0.700170879506001 5.229505263548706e-07 -0.0960960604798177 +1.2891000000000001 0.7001742335450214 0.700172949408655 5.227177729827392e-07 -0.09609722328086587 +1.2892000000000001 0.7001763148636495 0.7001750187031166 5.223571578755193e-07 -0.09609838574246118 +1.2893000000000001 0.700178395564949 0.7001770873909197 5.218687971209057e-07 -0.09609954786469865 +1.2894 0.7001804756477378 0.700179155473597 5.212528357695367e-07 -0.09610070964767334 +1.2895 0.7001825551108354 0.7001812229526784 5.205094475851935e-07 -0.09610187109148005 +1.2896 0.7001846339530633 0.700183289829692 5.196388351835779e-07 -0.09610303219621374 +1.2897 0.7001867121732459 0.7001853561061633 5.186412299074128e-07 -0.09610419296196933 +1.2898000000000003 0.7001887897702099 0.7001874217836156 5.175168917570527e-07 -0.09610535338884175 +1.2899 0.7001908667427854 0.7001894868635682 5.162661093904841e-07 -0.09610651347692581 +1.29 0.7001929430898053 0.7001915513475369 5.148891999429139e-07 -0.09610767322631622 +1.2901000000000002 0.7001950188101064 0.7001936152370345 5.133865090684031e-07 -0.09610883263710784 +1.2902 0.7001970939025297 0.700195678533569 5.117584107733331e-07 -0.09610999170939548 +1.2903000000000002 0.7001991683659206 0.7001977412386449 5.1000530726375e-07 -0.09611115044327384 +1.2904 0.7002012421991285 0.7001998033537611 5.081276290425096e-07 -0.0961123088388377 +1.2905 0.7002033154010079 0.7002018648804125 5.061258346733544e-07 -0.09611346689618175 +1.2906000000000002 0.7002053879704184 0.7002039258200878 5.040004105866247e-07 -0.0961146246154006 +1.2907 0.7002074599062253 0.7002059861742707 5.017518711347702e-07 -0.09611578199658898 +1.2908000000000002 0.7002095312072996 0.7002080459444391 4.993807583980603e-07 -0.09611693903984146 +1.2909000000000002 0.7002116018725179 0.7002101051320648 4.968876420596846e-07 -0.09611809574525271 +1.291 0.7002136719007637 0.7002121637386131 4.942731191975858e-07 -0.0961192521129173 +1.2911000000000001 0.7002157412909265 0.700214221765542 4.915378143122151e-07 -0.09612040814292976 +1.2912000000000001 0.7002178100419034 0.7002162792143037 4.886823789518324e-07 -0.09612156383538466 +1.2913000000000001 0.7002198781525983 0.7002183360863419 4.857074917541393e-07 -0.09612271919037645 +1.2914 0.7002219456219224 0.7002203923830935 4.82613858196479e-07 -0.09612387420799963 +1.2915 0.7002240124487951 0.7002224481059873 4.794022104293028e-07 -0.09612502888834872 +1.2916 0.7002260786321436 0.7002245032564439 4.76073307095759e-07 -0.09612618323151806 +1.2917 0.7002281441709033 0.7002265578358755 4.726279332484262e-07 -0.09612733723760213 +1.2918000000000003 0.7002302090640184 0.7002286118456857 4.6906690007175733e-07 -0.09612849090669527 +1.2919 0.7002322733104422 0.7002306652872693 4.6539104461840175e-07 -0.09612964423889192 +1.292 0.700234336909137 0.7002327181620112 4.616012297814498e-07 -0.09613079723428636 +1.2921 0.7002363998590739 0.7002347704712875 4.5769834400993803e-07 -0.09613194989297288 +1.2922 0.7002384621592348 0.7002368222164641 4.5368330111456023e-07 -0.09613310221504588 +1.2923000000000002 0.7002405238086107 0.7002388733988973 4.495570400248061e-07 -0.09613425420059958 +1.2924 0.7002425848062033 0.7002409240199321 4.4532052464324456e-07 -0.09613540584972818 +1.2925 0.7002446451510245 0.700242974080904 4.409747434777622e-07 -0.09613655716252595 +1.2926000000000002 0.700246704842097 0.7002450235831372 4.365207095721746e-07 -0.09613770813908706 +1.2927 0.7002487638784547 0.7002470725279448 4.31959460180098e-07 -0.09613885877950573 +1.2928000000000002 0.7002508222591428 0.7002491209166284 4.272920565775995e-07 -0.09614000908387604 +1.2929000000000002 0.7002528799832176 0.7002511687504781 4.225195837162521e-07 -0.09614115905229217 +1.293 0.7002549370497478 0.7002532160307724 4.176431501398681e-07 -0.09614230868484824 +1.2931000000000001 0.7002569934578133 0.7002552627587773 4.1266388753347094e-07 -0.09614345798163827 +1.2932000000000001 0.7002590492065068 0.7002573089357464 4.0758295057063965e-07 -0.09614460694275626 +1.2933000000000001 0.7002611042949335 0.7002593545629213 4.0240151668452517e-07 -0.09614575556829633 +1.2934 0.7002631587222112 0.7002613996415302 3.971207857417225e-07 -0.09614690385835245 +1.2935 0.7002652124874709 0.7002634441727887 3.917419796745092e-07 -0.09614805181301866 +1.2936 0.7002672655898563 0.7002654881578989 3.8626634237676205e-07 -0.09614919943238888 +1.2937 0.700269318028525 0.7002675315980489 3.8069513930150123e-07 -0.09615034671655699 +1.2938000000000003 0.700271369802648 0.7002695744944134 3.750296571833345e-07 -0.09615149366561694 +1.2939 0.7002734209114105 0.7002716168481534 3.692712037747792e-07 -0.09615264027966262 +1.294 0.7002754713540116 0.7002736586604156 3.6342110752013435e-07 -0.09615378655878792 +1.2941 0.7002775211296646 0.7002756999323321 3.5748071729180264e-07 -0.09615493250308663 +1.2942 0.7002795702375975 0.7002777406650202 3.5145140196701785e-07 -0.09615607811265257 +1.2943000000000002 0.7002816186770529 0.7002797808595826 3.4533455021967807e-07 -0.0961572233875795 +1.2944 0.7002836664472886 0.7002818205171073 3.391315701803399e-07 -0.09615836832796128 +1.2945 0.7002857135475773 0.7002838596386666 3.3284388909621265e-07 -0.09615951293389158 +1.2946000000000002 0.7002877599772075 0.7002858982253173 3.26472953025847e-07 -0.09616065720546414 +1.2947 0.7002898057354825 0.7002879362781007 3.2002022644361805e-07 -0.09616180114277262 +1.2948000000000002 0.700291850821722 0.7002899737980424 3.1348719197604735e-07 -0.09616294474591075 +1.2949000000000002 0.7002938952352613 0.7002920107861517 3.068753500548582e-07 -0.09616408801497214 +1.295 0.7002959389754522 0.700294047243422 3.001862185145199e-07 -0.09616523095005042 +1.2951000000000001 0.7002979820416619 0.7002960831708301 2.934213323077528e-07 -0.09616637355123918 +1.2952000000000001 0.7003000244332754 0.7002981185693364 2.865822431169507e-07 -0.09616751581863202 +1.2953000000000001 0.7003020661496934 0.7003001534398843 2.796705190141746e-07 -0.0961686577523225 +1.2954 0.7003041071903333 0.7003021877834004 2.726877440864528e-07 -0.09616979935240409 +1.2955 0.7003061475546305 0.7003042216007942 2.656355181096526e-07 -0.09617094061897033 +1.2956 0.7003081872420363 0.7003062548929582 2.5851545615296345e-07 -0.09617208155211468 +1.2957 0.70031022625202 0.7003082876607668 2.513291881833801e-07 -0.09617322215193058 +1.2958000000000003 0.7003122645840687 0.7003103199050777 2.440783587534523e-07 -0.09617436241851152 +1.2959 0.7003143022376863 0.7003123516267307 2.3676462656413433e-07 -0.09617550235195084 +1.296 0.7003163392123951 0.7003143828265472 2.2938966414559614e-07 -0.09617664195234199 +1.2961 0.7003183755077352 0.7003164135053312 2.2195515742007288e-07 -0.09617778121977832 +1.2962 0.7003204111232642 0.7003184436638684 2.1446280534798134e-07 -0.09617892015435311 +1.2963000000000002 0.7003224460585585 0.7003204733029261 2.0691431953934192e-07 -0.09618005875615976 +1.2964 0.7003244803132125 0.7003225024232533 1.9931142386866996e-07 -0.09618119702529146 +1.2965 0.7003265138868391 0.7003245310255803 1.9165585406558105e-07 -0.09618233496184155 +1.2966000000000002 0.70032854677907 0.7003265591106191 1.8394935731580464e-07 -0.09618347256590323 +1.2967 0.7003305789895551 0.7003285866790625 1.761936918483198e-07 -0.09618460983756973 +1.2968000000000002 0.7003326105179632 0.7003306137315849 1.6839062660228832e-07 -0.0961857467769342 +1.2969000000000002 0.7003346413639827 0.7003326402688415 1.6054194074480166e-07 -0.09618688338408991 +1.297 0.7003366715273199 0.7003346662914683 1.5264942331699727e-07 -0.09618801965912996 +1.2971000000000001 0.700338701007701 0.7003366918000822 1.4471487280037776e-07 -0.09618915560214744 +1.2972000000000001 0.7003407298048709 0.7003387167952809 1.3674009671435505e-07 -0.0961902912132355 +1.2973000000000001 0.7003427579185943 0.7003407412776425 1.287269112033862e-07 -0.09619142649248719 +1.2974 0.7003447853486549 0.7003427652477257 1.2067714062410917e-07 -0.09619256143999554 +1.2975 0.7003468120948555 0.7003447887060699 1.1259261715329538e-07 -0.09619369605585357 +1.2976 0.7003488381570192 0.7003468116531946 1.0447518031253544e-07 -0.0961948303401543 +1.2977 0.7003508635349885 0.7003488340895998 9.632667662476391e-08 -0.09619596429299077 +1.2978000000000003 0.7003528882286252 0.7003508560157654 8.814895912159781e-08 -0.09619709791445584 +1.2979 0.7003549122378117 0.7003528774321519 7.994388697904475e-08 -0.0961982312046425 +1.298 0.7003569355624488 0.7003548983391995 7.171332507341366e-08 -0.09619936416364366 +1.2981 0.7003589582024583 0.700356918737329 6.345914355110338e-08 -0.0962004967915522 +1.2982 0.7003609801577816 0.7003589386269404 5.5183217400125995e-08 -0.09620162908846094 +1.2983000000000002 0.7003630014283798 0.7003609580084142 4.6887426045916225e-08 -0.09620276105446272 +1.2984 0.7003650220142346 0.7003629768821114 3.857365290724224e-08 -0.09620389268965045 +1.2985 0.7003670419153473 0.7003649952483713 3.024378498507618e-08 -0.09620502399411683 +1.2986000000000002 0.7003690611317389 0.700367013107514 2.189971240983135e-08 -0.09620615496795462 +1.2987 0.7003710796634515 0.7003690304598398 1.3543328033702173e-08 -0.0962072856112566 +1.2988000000000002 0.7003730975105462 0.7003710473056277 5.176526992646535e-09 -0.09620841592411548 +1.2989000000000002 0.7003751146731051 0.7003730636451377 -3.1987937246930054e-09 -0.09620954590662391 +1.299 0.7003771311512301 0.7003750794786084 -1.15807356967923e-08 -0.09621067555887464 +1.2991000000000001 0.7003791469450436 0.7003770948062593 -1.9967399517671625e-08 -0.0962118048809603 +1.2992000000000001 0.7003811620546874 0.7003791096282882 -2.835688520759147e-08 -0.09621293387297344 +1.2993000000000001 0.7003831764803243 0.7003811239448741 -3.674729265605754e-08 -0.09621406253500676 +1.2994 0.700385190222137 0.7003831377561747 -4.513672204899642e-08 -0.0962151908671528 +1.2995 0.7003872032803278 0.700385151062328 -5.3523274294413337e-08 -0.09621631886950409 +1.2996 0.7003892156551202 0.7003871638634516 -6.190505145780775e-08 -0.09621744654215318 +1.2997 0.700391227346757 0.7003891761596429 -7.02801571913006e-08 -0.09621857388519256 +1.2998000000000003 0.7003932383555014 0.700391187950979 -7.864669715777414e-08 -0.09621970089871475 +1.2999 0.7003952486816365 0.7003931992375168 -8.700277946433604e-08 -0.09622082758281215 +1.3 0.700397258325466 0.7003952100192931 -9.534651508602554e-08 -0.09622195393757721 +1.3001 0.7003992672873129 0.7003972202963247 -1.0367601829732592e-07 -0.09622307996310236 +1.3002 0.700401275567521 0.7003992300686083 -1.119894070967381e-07 -0.09622420565948002 +1.3003000000000002 0.7004032831664531 0.7004012393361205 -1.2028480362961946e-07 -0.09622533102680249 +1.3004 0.7004052900844925 0.700403248098818 -1.2856033461232375e-07 -0.09622645606516216 +1.3005 0.7004072963220422 0.7004052563566375 -1.3681413175634094e-07 -0.0962275807746513 +1.3006000000000002 0.700409301879525 0.7004072641094959 -1.4504433219937607e-07 -0.09622870515536225 +1.3007 0.7004113067573832 0.70040927135729 -1.5324907889913142e-07 -0.09622982920738718 +1.3008000000000002 0.7004133109560791 0.7004112780998972 -1.614265210878041e-07 -0.09623095293081846 +1.3009000000000002 0.7004153144760942 0.7004132843371753 -1.6957481466239877e-07 -0.09623207632574823 +1.301 0.7004173173179298 0.7004152900689627 -1.7769212260626555e-07 -0.09623319939226878 +1.3011000000000001 0.7004193194821066 0.7004172952950776 -1.8577661540369883e-07 -0.09623432213047221 +1.3012000000000001 0.7004213209691641 0.7004193000153189 -1.9382647149096544e-07 -0.09623544454045065 +1.3013000000000001 0.7004233217796618 0.700421304229467 -2.0183987758590205e-07 -0.0962365666222963 +1.3014000000000001 0.7004253219141781 0.7004233079372822 -2.0981502916322947e-07 -0.09623768837610125 +1.3015 0.7004273213733101 0.7004253111385057 -2.1775013083272232e-07 -0.09623880980195751 +1.3016 0.7004293201576743 0.7004273138328603 -2.2564339675207323e-07 -0.09623993089995722 +1.3017 0.700431318267906 0.700429316020049 -2.3349305103281814e-07 -0.09624105167019238 +1.3018000000000003 0.7004333157046587 0.7004313176997566 -2.4129732812891436e-07 -0.09624217211275499 +1.3019 0.7004353124686051 0.7004333188716494 -2.490544732253186e-07 -0.09624329222773705 +1.302 0.7004373085604363 0.7004353195353741 -2.56762742664729e-07 -0.09624441201523051 +1.3021 0.7004393039808617 0.7004373196905597 -2.644204043153464e-07 -0.09624553147532729 +1.3022 0.700441298730609 0.7004393193368169 -2.720257379733304e-07 -0.09624665060811936 +1.3023000000000002 0.7004432928104241 0.700441318473738 -2.795770357166827e-07 -0.09624776941369861 +1.3024 0.7004452862210703 0.700443317100897 -2.8707260235280585e-07 -0.09624888789215685 +1.3025 0.7004472789633296 0.7004453152178505 -2.9451075570646745e-07 -0.09625000604358601 +1.3026000000000002 0.7004492710380011 0.7004473128241366 -3.0188982710205314e-07 -0.09625112386807781 +1.3027 0.7004512624459021 0.7004493099192766 -3.0920816165846965e-07 -0.09625224136572418 +1.3028000000000002 0.7004532531878661 0.7004513065027733 -3.1646411869507007e-07 -0.09625335853661675 +1.3029000000000002 0.7004552432647451 0.7004533025741131 -3.236560720959458e-07 -0.09625447538084732 +1.303 0.7004572326774077 0.7004552981327647 -3.307824106846269e-07 -0.09625559189850769 +1.3031000000000001 0.7004592214267392 0.7004572931781801 -3.3784153853633203e-07 -0.09625670808968945 +1.3032000000000001 0.7004612095136422 0.700459287709794 -3.448318754081803e-07 -0.09625782395448437 +1.3033000000000001 0.7004631969390354 0.7004612817270248 -3.517518570236855e-07 -0.09625893949298406 +1.3034000000000001 0.7004651837038539 0.7004632752292743 -3.585999354613345e-07 -0.09626005470528015 +1.3035 0.7004671698090494 0.700465268215928 -3.653745795223484e-07 -0.09626116959146427 +1.3036 0.7004691552555897 0.700467260686355 -3.720742750082384e-07 -0.09626228415162805 +1.3037 0.7004711400444579 0.700469252639909 -3.786975251232616e-07 -0.09626339838586298 +1.3038000000000003 0.7004731241766535 0.7004712440759274 -3.852428507589156e-07 -0.09626451229426068 +1.3039 0.7004751076531905 0.7004732349937322 -3.9170879089639454e-07 -0.09626562587691254 +1.304 0.7004770904750994 0.7004752253926296 -3.9809390282863344e-07 -0.09626673913391011 +1.3041 0.7004790726434251 0.7004772152719119 -4.0439676255582535e-07 -0.09626785206534495 +1.3042 0.7004810541592272 0.7004792046308548 -4.106159650837937e-07 -0.09626896467130838 +1.3043000000000002 0.7004830350235806 0.7004811934687205 -4.167501247570593e-07 -0.09627007695189191 +1.3044 0.7004850152375742 0.7004831817847559 -4.2279787551557924e-07 -0.09627118890718689 +1.3045 0.7004869948023114 0.7004851695781936 -4.287578712625084e-07 -0.09627230053728471 +1.3046000000000002 0.7004889737189095 0.7004871568482525 -4.346287860862441e-07 -0.09627341184227674 +1.3047 0.7004909519884996 0.7004891435941372 -4.404093146559429e-07 -0.0962745228222543 +1.3048000000000002 0.7004929296122266 0.7004911298150382 -4.460981724435653e-07 -0.09627563347730861 +1.3049000000000002 0.7004949065912487 0.7004931155101338 -4.516940960083704e-07 -0.09627674380753108 +1.305 0.7004968829267375 0.7004951006785878 -4.571958433022272e-07 -0.09627785381301292 +1.3051000000000001 0.7004988586198768 0.7004970853195516 -4.6260219396104807e-07 -0.09627896349384533 +1.3052000000000001 0.700500833671864 0.7004990694321638 -4.679119495060169e-07 -0.09628007285011958 +1.3053000000000001 0.7005028080839082 0.7005010530155499 -4.731239336905335e-07 -0.0962811818819268 +1.3054000000000001 0.7005047818572312 0.7005030360688238 -4.782369926945029e-07 -0.0962822905893582 +1.3055 0.7005067549930666 0.7005050185910875 -4.83249995464341e-07 -0.09628339897250493 +1.3056 0.7005087274926596 0.7005070005814298 -4.881618338309357e-07 -0.09628450703145802 +1.3057 0.7005106993572672 0.7005089820389296 -4.929714228912863e-07 -0.09628561476630865 +1.3058 0.7005126705881572 0.7005109629626536 -4.976777011750366e-07 -0.09628672217714788 +1.3059 0.700514641186609 0.7005129433516576 -5.022796308942756e-07 -0.09628782926406675 +1.306 0.7005166111539118 0.7005149232049867 -5.067761981794594e-07 -0.09628893602715628 +1.3061 0.7005185804913666 0.7005169025216749 -5.111664132390059e-07 -0.09629004246650752 +1.3062 0.7005205492002831 0.7005188813007466 -5.154493107270564e-07 -0.09629114858221134 +1.3063000000000002 0.7005225172819821 0.7005208595412156 -5.196239497851085e-07 -0.09629225437435877 +1.3064 0.7005244847377936 0.7005228372420866 -5.236894143403892e-07 -0.09629335984304077 +1.3065 0.700526451569057 0.7005248144023544 -5.276448133625933e-07 -0.0962944649883482 +1.3066000000000002 0.7005284177771209 0.7005267910210042 -5.314892808708227e-07 -0.09629556981037193 +1.3067 0.7005303833633427 0.7005287670970126 -5.352219763291033e-07 -0.0962966743092028 +1.3068000000000002 0.7005323483290888 0.7005307426293477 -5.388420847088349e-07 -0.09629777848493175 +1.3069000000000002 0.7005343126757337 0.7005327176169689 -5.423488166900192e-07 -0.09629888233764954 +1.307 0.7005362764046597 0.7005346920588273 -5.457414088971824e-07 -0.09629998586744692 +1.3071000000000002 0.700538239517257 0.7005366659538669 -5.490191239063136e-07 -0.09630108907441476 +1.3072000000000001 0.7005402020149236 0.7005386393010231 -5.521812506403823e-07 -0.0963021919586437 +1.3073000000000001 0.7005421638990643 0.7005406120992244 -5.552271043207657e-07 -0.09630329452022447 +1.3074000000000001 0.7005441251710911 0.7005425843473925 -5.581560266892938e-07 -0.09630439675924783 +1.3075 0.7005460858324226 0.7005445560444419 -5.609673861539655e-07 -0.09630549867580437 +1.3076 0.7005480458844842 0.7005465271892812 -5.63660577934666e-07 -0.09630660026998486 +1.3077 0.7005500053287064 0.7005484977808127 -5.662350241603109e-07 -0.09630770154187984 +1.3078 0.7005519641665263 0.7005504678179322 -5.686901739798689e-07 -0.09630880249157993 +1.3079 0.7005539223993862 0.7005524372995305 -5.710255038537948e-07 -0.09630990311917574 +1.308 0.7005558800287337 0.7005544062244932 -5.732405172903521e-07 -0.09631100342475779 +1.3081 0.7005578370560213 0.7005563745917003 -5.75334745400724e-07 -0.09631210340841663 +1.3082 0.7005597934827059 0.7005583424000279 -5.773077466769694e-07 -0.09631320307024278 +1.3083000000000002 0.7005617493102492 0.7005603096483466 -5.791591072140667e-07 -0.09631430241032671 +1.3084 0.7005637045401165 0.7005622763355239 -5.808884407654258e-07 -0.09631540142875891 +1.3085 0.7005656591737774 0.7005642424604228 -5.824953888400319e-07 -0.09631650012562983 +1.3086000000000002 0.7005676132127044 0.7005662080219033 -5.839796207579573e-07 -0.09631759850102986 +1.3087 0.7005695666583733 0.7005681730188211 -5.853408337197497e-07 -0.09631869655504936 +1.3088000000000002 0.700571519512263 0.7005701374500304 -5.865787528480659e-07 -0.09631979428777877 +1.3089000000000002 0.7005734717758545 0.700572101314382 -5.876931313680833e-07 -0.09632089169930841 +1.309 0.7005754234506314 0.7005740646107241 -5.886837504409659e-07 -0.09632198878972865 +1.3091000000000002 0.7005773745380792 0.7005760273379036 -5.895504193581536e-07 -0.09632308555912975 +1.3092000000000001 0.7005793250396852 0.7005779894947646 -5.902929755691178e-07 -0.09632418200760197 +1.3093000000000001 0.700581274956938 0.7005799510801507 -5.909112846813613e-07 -0.09632527813523561 +1.3094000000000001 0.7005832242913266 0.7005819120929041 -5.914052404465409e-07 -0.09632637394212087 +1.3095 0.7005851730443418 0.7005838725318657 -5.917747648437333e-07 -0.09632746942834797 +1.3096 0.7005871212174744 0.7005858323958767 -5.920198080794359e-07 -0.09632856459400711 +1.3097 0.7005890688122149 0.7005877916837769 -5.921403485459331e-07 -0.0963296594391884 +1.3098 0.7005910158300548 0.7005897503944074 -5.92136392779663e-07 -0.09633075396398208 +1.3099 0.7005929622724842 0.7005917085266087 -5.92007975613873e-07 -0.09633184816847822 +1.31 0.7005949081409923 0.7005936660792225 -5.917551601231086e-07 -0.09633294205276685 +1.3101 0.7005968534370683 0.7005956230510911 -5.913780374150468e-07 -0.09633403561693814 +1.3102 0.7005987981621993 0.7005975794410582 -5.908767267692738e-07 -0.09633512886108206 +1.3103000000000002 0.7006007423178705 0.7005995352479691 -5.902513755956518e-07 -0.09633622178528865 +1.3104 0.7006026859055661 0.7006014904706709 -5.895021593371741e-07 -0.09633731438964795 +1.3105 0.7006046289267673 0.7006034451080128 -5.886292815671101e-07 -0.09633840667424991 +1.3106000000000002 0.7006065713829532 0.7006053991588467 -5.876329736420605e-07 -0.0963394986391845 +1.3107 0.7006085132755997 0.7006073526220267 -5.865134949101236e-07 -0.09634059028454164 +1.3108000000000002 0.7006104546061799 0.7006093054964104 -5.852711325304849e-07 -0.09634168161041126 +1.3109000000000002 0.7006123953761632 0.7006112577808585 -5.839062014734164e-07 -0.0963427726168832 +1.311 0.7006143355870155 0.7006132094742358 -5.824190443398658e-07 -0.09634386330404737 +1.3111000000000002 0.7006162752401983 0.7006151605754103 -5.808100313475784e-07 -0.09634495367199357 +1.3112000000000001 0.7006182143371699 0.7006171110832545 -5.790795603033416e-07 -0.09634604372081167 +1.3113000000000001 0.7006201528793824 0.7006190609966458 -5.772280562976739e-07 -0.09634713345059143 +1.3114000000000001 0.7006220908682841 0.7006210103144659 -5.752559717742134e-07 -0.09634822286142258 +1.3115 0.700624028305318 0.7006229590356017 -5.731637864048178e-07 -0.09634931195339494 +1.3116 0.7006259651919213 0.7006249071589453 -5.709520068813978e-07 -0.09635040072659817 +1.3117 0.7006279015295258 0.7006268546833951 -5.686211669159169e-07 -0.09635148918112202 +1.3118 0.700629837319557 0.7006288016078547 -5.66171827073858e-07 -0.09635257731705614 +1.3119 0.7006317725634343 0.7006307479312344 -5.636045745244234e-07 -0.09635366513449022 +1.312 0.7006337072625702 0.7006326936524507 -5.609200230960454e-07 -0.09635475263351381 +1.3121 0.7006356414183706 0.7006346387704276 -5.581188129849535e-07 -0.09635583981421662 +1.3122 0.7006375750322342 0.7006365832840951 -5.552016106163959e-07 -0.09635692667668816 +1.3123000000000002 0.7006395081055523 0.7006385271923907 -5.521691085891289e-07 -0.096358013221018 +1.3124 0.7006414406397081 0.7006404704942609 -5.490220253562272e-07 -0.09635909944729573 +1.3125 0.7006433726360772 0.7006424131886585 -5.457611052250844e-07 -0.0963601853556108 +1.3126000000000002 0.700645304096027 0.7006443552745453 -5.423871180451623e-07 -0.09636127094605275 +1.3127 0.7006472350209159 0.7006462967508912 -5.38900859103908e-07 -0.09636235621871103 +1.3128000000000002 0.7006491654120941 0.700648237616675 -5.353031488769533e-07 -0.09636344117367511 +1.3129000000000002 0.7006510952709023 0.7006501778708845 -5.315948329240316e-07 -0.0963645258110344 +1.313 0.7006530245986722 0.7006521175125165 -5.27776781611422e-07 -0.0963656101308783 +1.3131000000000002 0.7006549533967252 0.7006540565405777 -5.23849889931538e-07 -0.09636669413329615 +1.3132000000000001 0.7006568816663739 0.700655994954084 -5.198150773502719e-07 -0.09636777781837737 +1.3133000000000001 0.7006588094089199 0.700657932752062 -5.156732874808667e-07 -0.09636886118621125 +1.3134000000000001 0.7006607366256552 0.700659869933548 -5.11425487917383e-07 -0.09636994423688716 +1.3135 0.7006626633178603 0.7006618064975894 -5.070726700820427e-07 -0.09637102697049432 +1.3136 0.7006645894868055 0.7006637424432436 -5.026158488227739e-07 -0.09637210938712198 +1.3137 0.7006665151337498 0.7006656777695797 -4.980560624132102e-07 -0.09637319148685945 +1.3138 0.7006684402599406 0.7006676124756777 -4.933943720808465e-07 -0.09637427326979586 +1.3139 0.7006703648666139 0.7006695465606295 -4.886318619445884e-07 -0.09637535473602046 +1.314 0.700672288954994 0.7006714800235384 -4.83769638605358e-07 -0.09637643588562239 +1.3141 0.7006742125262931 0.7006734128635198 -4.788088309864991e-07 -0.09637751671869084 +1.3142 0.7006761355817108 0.7006753450797014 -4.7375059006316e-07 -0.09637859723531489 +1.3143000000000002 0.7006780581224342 0.7006772766712233 -4.685960885431051e-07 -0.09637967743558368 +1.3144 0.700679980149638 0.7006792076372381 -4.633465206793641e-07 -0.09638075731958623 +1.3145 0.7006819016644837 0.700681137976912 -4.5800310192328775e-07 -0.09638183688741174 +1.3146000000000002 0.7006838226681193 0.7006830676894233 -4.5256706869556407e-07 -0.0963829161391491 +1.3147 0.7006857431616795 0.7006849967739646 -4.4703967801151823e-07 -0.09638399507488736 +1.3148000000000002 0.7006876631462855 0.7006869252297412 -4.4142220730070125e-07 -0.09638507369471548 +1.3149000000000002 0.7006895826230446 0.7006888530559731 -4.35715954080762e-07 -0.09638615199872247 +1.315 0.7006915015930497 0.7006907802518936 -4.2992223561744147e-07 -0.09638722998699722 +1.3151000000000002 0.70069342005738 0.7006927068167506 -4.2404238863313903e-07 -0.09638830765962873 +1.3152000000000001 0.7006953380170995 0.7006946327498063 -4.1807776898772353e-07 -0.0963893850167058 +1.3153000000000001 0.7006972554732582 0.7006965580503373 -4.1202975145648857e-07 -0.09639046205831736 +1.3154000000000001 0.7006991724268905 0.7006984827176354 -4.058997293138189e-07 -0.09639153878455228 +1.3155 0.7007010888790166 0.7007004067510068 -3.996891140209402e-07 -0.09639261519549931 +1.3156 0.7007030048306404 0.7007023301497737 -3.933993349761189e-07 -0.09639369129124732 +1.3157 0.700704920282751 0.7007042529132731 -3.870318391191452e-07 -0.09639476707188507 +1.3158 0.7007068352363217 0.7007061750408576 -3.805880905566328e-07 -0.0963958425375013 +1.3159 0.7007087496923099 0.7007080965318957 -3.7406957035385213e-07 -0.09639691768818473 +1.316 0.7007106636516571 0.7007100173857721 -3.674777761183967e-07 -0.09639799252402417 +1.3161 0.7007125771152889 0.7007119376018869 -3.608142216324217e-07 -0.09639906704510821 +1.3162 0.7007144900841136 0.7007138571796566 -3.540804365403938e-07 -0.09640014125152555 +1.3163000000000002 0.700716402559024 0.7007157761185148 -3.472779660368408e-07 -0.0964012151433648 +1.3164 0.700718314540896 0.7007176944179107 -3.404083703875682e-07 -0.09640228872071463 +1.3165 0.7007202260305885 0.7007196120773111 -3.334732247284311e-07 -0.09640336198366366 +1.3166000000000002 0.7007221370289431 0.7007215290961994 -3.264741185934894e-07 -0.09640443493230041 +1.3167 0.700724047536785 0.7007234454740756 -3.1941265560969656e-07 -0.0964055075667134 +1.3168000000000002 0.7007259575549216 0.7007253612104576 -3.122904530805659e-07 -0.09640657988699124 +1.3169000000000002 0.7007278670841431 0.70072727630488 -3.0510914164616487e-07 -0.09640765189322238 +1.317 0.7007297761252222 0.7007291907568952 -2.9787036493617025e-07 -0.09640872358549533 +1.3171000000000002 0.7007316846789136 0.7007311045660735 -2.905757791327179e-07 -0.09640979496389854 +1.3172000000000001 0.7007335927459544 0.7007330177320021 -2.8322705263733594e-07 -0.09641086602852045 +1.3173000000000001 0.7007355003270639 0.7007349302542869 -2.7582586567542755e-07 -0.09641193677944948 +1.3174000000000001 0.7007374074229429 0.7007368421325515 -2.6837390990769316e-07 -0.09641300721677402 +1.3175 0.7007393140342746 0.7007387533664369 -2.608728880415523e-07 -0.09641407734058242 +1.3176 0.7007412201617234 0.7007406639556035 -2.533245134529738e-07 -0.09641514715096304 +1.3177 0.7007431258059352 0.7007425738997293 -2.4573050983259237e-07 -0.09641621664800419 +1.3178 0.7007450309675383 0.7007444831985108 -2.38092610693047e-07 -0.0964172858317942 +1.3179 0.7007469356471414 0.700746391851663 -2.304125590532613e-07 -0.09641835470242133 +1.318 0.700748839845335 0.7007482998589197 -2.2269210702904885e-07 -0.09641942325997382 +1.3181 0.7007507435626905 0.7007502072200333 -2.1493301540984056e-07 -0.09642049150453993 +1.3182 0.7007526467997607 0.7007521139347752 -2.0713705326663723e-07 -0.0964215594362079 +1.3183000000000002 0.7007545495570794 0.7007540200029351 -1.9930599758077872e-07 -0.0964226270550658 +1.3184 0.7007564518351612 0.7007559254243223 -1.9144163279291582e-07 -0.09642369436120192 +1.3185 0.7007583536345015 0.7007578301987648 -1.8354575039708498e-07 -0.09642476135470435 +1.3186000000000002 0.7007602549555768 0.70075973432611 -1.756201486076414e-07 -0.0964258280356612 +1.3187 0.7007621557988444 0.7007616378062239 -1.67666631838842e-07 -0.09642689440416059 +1.3188000000000002 0.7007640561647415 0.7007635406389924 -1.5968701037004374e-07 -0.09642796046029056 +1.3189000000000002 0.7007659560536866 0.7007654428243202 -1.516830999206964e-07 -0.09642902620413916 +1.319 0.700767855466079 0.7007673443621318 -1.4365672120972284e-07 -0.09643009163579445 +1.3191000000000002 0.7007697544022979 0.7007692452523706 -1.3560969958949232e-07 -0.09643115675534442 +1.3192000000000002 0.7007716528627033 0.7007711454949999 -1.275438645739757e-07 -0.09643222156287702 +1.3193000000000001 0.7007735508476355 0.700773045090002 -1.194610494623105e-07 -0.09643328605848024 +1.3194000000000001 0.7007754483574153 0.7007749440373789 -1.1136309092246721e-07 -0.096434350242242 +1.3195 0.700777345392344 0.7007768423371525 -1.0325182854716008e-07 -0.09643541411425023 +1.3196 0.7007792419527028 0.700778739989364 -9.512910446006495e-08 -0.0964364776745928 +1.3197 0.7007811380387536 0.700780636994074 -8.699676289254665e-08 -0.09643754092335761 +1.3198 0.7007830336507388 0.700782533351363 -7.885664975604972e-08 -0.09643860386063251 +1.3199 0.7007849287888803 0.7007844290613311 -7.071061222836683e-08 -0.09643966648650529 +1.32 0.700786823453381 0.7007863241240979 -6.2560498342943e-08 -0.09644072880106376 +1.3201 0.7007887176444241 0.7007882185398027 -5.4408156559965226e-08 -0.09644179080439576 +1.3202 0.7007906113621722 0.7007901123086042 -4.62554353454752e-08 -0.09644285249658892 +1.3203000000000003 0.7007925046067691 0.7007920054306812 -3.8104182760402474e-08 -0.09644391387773103 +1.3204 0.7007943973783387 0.7007938979062318 -2.995624603712929e-08 -0.09644497494790984 +1.3205 0.7007962896769849 0.7007957897354739 -2.1813471161313824e-08 -0.09644603570721295 +1.3206000000000002 0.7007981815027923 0.7007976809186447 -1.3677702453713386e-08 -0.0964470961557281 +1.3207 0.7008000728558255 0.7007995714560014 -5.550782155097633e-09 -0.09644815629354289 +1.3208000000000002 0.7008019637361296 0.7008014613478203 2.565449993933988e-09 -0.09644921612074499 +1.3209000000000002 0.70080385414373 0.7008033505943975 1.0669157167984833e-08 -0.0964502756374219 +1.321 0.7008057440786328 0.7008052391960484 1.8758505875363096e-08 -0.09645133484366125 +1.3211000000000002 0.7008076335408246 0.7008071271531082 2.6831666369644958e-08 -0.09645239373955064 +1.3212000000000002 0.7008095225302722 0.7008090144659311 3.488681305299779e-08 -0.09645345232517756 +1.3213000000000001 0.700811411046923 0.7008109011348908 4.292212492200409e-08 -0.09645451060062947 +1.3214000000000001 0.7008132990907052 0.7008127871603798 5.093578593975967e-08 -0.09645556856599385 +1.3215 0.7008151866615275 0.7008146725428108 5.8925985466085073e-08 -0.09645662622135823 +1.3216 0.7008170737592798 0.700816557282615 6.689091867038977e-08 -0.09645768356680999 +1.3217 0.7008189603838326 0.7008184413802427 7.48287869358627e-08 -0.09645874060243659 +1.3218 0.7008208465350367 0.7008203248361637 8.273779824284622e-08 -0.0964597973283254 +1.3219 0.7008227322127246 0.7008222076508662 9.061616762159885e-08 -0.09646085374456376 +1.322 0.7008246174167094 0.7008240898248577 9.846211749750533e-08 -0.09646190985123909 +1.3221 0.7008265021467857 0.7008259713586641 1.0627387815598244e-07 -0.09646296564843863 +1.3222 0.7008283864027287 0.7008278522528302 1.140496880720765e-07 -0.0964640211362497 +1.3223000000000003 0.7008302701842959 0.7008297325079198 1.2178779435975673e-07 -0.09646507631475967 +1.3224 0.700832153491225 0.7008316121245144 1.294864531639628e-07 -0.09646613118405567 +1.3225 0.7008340363232357 0.7008334911032146 1.3714393002142722e-07 -0.09646718574422497 +1.3226000000000002 0.70083591868003 0.7008353694446389 1.447585002561924e-07 -0.09646823999535481 +1.3227 0.7008378005612907 0.7008372471494245 1.523284494132915e-07 -0.0964692939375324 +1.3228000000000002 0.7008396819666824 0.7008391242182261 1.5985207359528464e-07 -0.09647034757084483 +1.3229000000000002 0.7008415628958524 0.7008410006517166 1.6732767986471497e-07 -0.09647140089537926 +1.323 0.7008434433484296 0.700842876450587 1.7475358662227825e-07 -0.09647245391122287 +1.3231000000000002 0.7008453233240248 0.7008447516155456 1.8212812399193146e-07 -0.09647350661846271 +1.3232000000000002 0.7008472028222315 0.700846626147319 1.894496341851848e-07 -0.09647455901718588 +1.3233000000000001 0.7008490818426258 0.7008485000466501 1.9671647189661856e-07 -0.09647561110747942 +1.3234000000000001 0.7008509603847658 0.7008503733143003 2.0392700462654179e-07 -0.09647666288943035 +1.3235 0.7008528384481929 0.7008522459510478 2.1107961310773415e-07 -0.0964777143631257 +1.3236 0.700854716032431 0.7008541179576875 2.181726916142268e-07 -0.09647876552865245 +1.3237 0.7008565931369872 0.7008559893350311 2.2520464838804433e-07 -0.09647981638609751 +1.3238 0.7008584697613518 0.700857860083908 2.3217390588553544e-07 -0.0964808669355479 +1.3239 0.7008603459049985 0.7008597302051633 2.3907890125962616e-07 -0.09648191717709054 +1.324 0.700862221567384 0.7008615996996588 2.4591808664431447e-07 -0.09648296711081221 +1.3241 0.7008640967479493 0.7008634685682724 2.5268992948773716e-07 -0.09648401673679988 +1.3242 0.7008659714461185 0.7008653368118984 2.593929129129924e-07 -0.09648506605514034 +1.3243000000000003 0.7008678456613008 0.7008672044314471 2.6602553608590096e-07 -0.09648611506592053 +1.3244 0.7008697193928886 0.700869071427844 2.7258631453419557e-07 -0.09648716376922717 +1.3245 0.7008715926402584 0.7008709378020306 2.7907378043201536e-07 -0.09648821216514702 +1.3246000000000002 0.7008734654027724 0.7008728035549635 2.854864830093007e-07 -0.09648926025376686 +1.3247 0.7008753376797766 0.700874668687615 2.918229888085322e-07 -0.09649030803517349 +1.3248000000000002 0.7008772094706024 0.7008765332009723 2.980818820386144e-07 -0.09649135550945359 +1.3249000000000002 0.7008790807745656 0.7008783970960366 3.0426176491488155e-07 -0.09649240267669382 +1.325 0.7008809515909679 0.7008802603738249 3.103612578950199e-07 -0.09649344953698086 +1.3251000000000002 0.7008828219190963 0.7008821230353679 3.1637900006070696e-07 -0.0964944960904014 +1.3252000000000002 0.7008846917582237 0.7008839850817106 3.223136493743506e-07 -0.09649554233704202 +1.3253000000000001 0.7008865611076083 0.7008858465139123 3.281638830399114e-07 -0.09649658827698931 +1.3254000000000001 0.7008884299664948 0.7008877073330457 3.3392839770413074e-07 -0.09649763391032987 +1.3255 0.7008902983341144 0.7008895675401979 3.3960590982429206e-07 -0.09649867923715028 +1.3256000000000001 0.7008921662096844 0.7008914271364686 3.4519515593883776e-07 -0.09649972425753703 +1.3257 0.7008940335924092 0.7008932861229706 3.5069489293104716e-07 -0.09650076897157667 +1.3258 0.7008959004814801 0.7008951445008309 3.561038982788367e-07 -0.09650181337935572 +1.3259 0.700897766876075 0.7008970022711875 3.614209704294602e-07 -0.09650285748096057 +1.326 0.7008996327753602 0.700898859435192 3.666449289382867e-07 -0.09650390127647773 +1.3261 0.7009014981784888 0.7009007159940082 3.7177461482268415e-07 -0.09650494476599358 +1.3262 0.7009033630846018 0.7009025719488116 3.768088907840639e-07 -0.09650598794959453 +1.3263000000000003 0.7009052274928294 0.7009044273007897 3.8174664141604753e-07 -0.09650703082736699 +1.3264 0.7009070914022886 0.7009062820511416 3.865867735652895e-07 -0.09650807339939727 +1.3265 0.7009089548120859 0.7009081362010776 3.9132821647025473e-07 -0.09650911566577174 +1.3266000000000002 0.7009108177213166 0.7009099897518196 3.959699220387747e-07 -0.09651015762657669 +1.3267 0.7009126801290644 0.7009118427045995 4.005108650839695e-07 -0.09651119928189841 +1.3268000000000002 0.7009145420344032 0.7009136950606605 4.0495004352547603e-07 -0.09651224063182318 +1.3269000000000002 0.7009164034363958 0.700915546821256 4.0928647865312584e-07 -0.09651328167643726 +1.327 0.7009182643340952 0.7009173979876491 4.135192152587841e-07 -0.0965143224158268 +1.3271000000000002 0.7009201247265441 0.7009192485611135 4.1764732200411103e-07 -0.09651536285007808 +1.3272 0.7009219846127757 0.7009210985429318 4.2166989145525635e-07 -0.09651640297927722 +1.3273000000000001 0.7009238439918141 0.700922947934396 4.2558604036041503e-07 -0.09651744280351038 +1.3274000000000001 0.7009257028626736 0.700924796736808 4.293949098510552e-07 -0.09651848232286372 +1.3275 0.7009275612243597 0.7009266449514774 4.330956656084517e-07 -0.09651952153742331 +1.3276000000000001 0.7009294190758701 0.7009284925797233 4.3668749803715823e-07 -0.09652056044727532 +1.3277 0.7009312764161932 0.7009303396228725 4.4016962249399105e-07 -0.09652159905250575 +1.3278 0.7009331332443095 0.7009321860822599 4.43541279412929e-07 -0.09652263735320062 +1.3279 0.7009349895591918 0.7009340319592283 4.4680173444389126e-07 -0.09652367534944599 +1.328 0.700936845359805 0.7009358772551282 4.499502787164156e-07 -0.09652471304132787 +1.3281 0.7009387006451074 0.7009377219713167 4.529862288604747e-07 -0.09652575042893217 +1.3282 0.7009405554140495 0.700939566109158 4.5590892729791e-07 -0.09652678751234486 +1.3283000000000003 0.7009424096655759 0.7009414096700237 4.5871774222855377e-07 -0.09652782429165196 +1.3284 0.7009442633986237 0.700943252655291 4.614120678800293e-07 -0.09652886076693931 +1.3285 0.7009461166121246 0.7009450950663436 4.63991324632651e-07 -0.09652989693829284 +1.3286000000000002 0.7009479693050041 0.7009469369045704 4.664549591026912e-07 -0.09653093280579832 +1.3287 0.7009498214761822 0.7009487781713668 4.6880244425340223e-07 -0.09653196836954168 +1.3288000000000002 0.7009516731245732 0.7009506188681324 4.710332795476724e-07 -0.09653300362960865 +1.3289000000000002 0.7009535242490869 0.7009524589962728 4.7314699103129243e-07 -0.0965340385860851 +1.329 0.7009553748486278 0.7009542985571976 4.751431314370391e-07 -0.09653507323905679 +1.3291000000000002 0.700957224922096 0.7009561375523213 4.770212803373308e-07 -0.09653610758860945 +1.3292 0.7009590744683876 0.7009579759830622 4.787810440193274e-07 -0.09653714163482885 +1.3293000000000001 0.7009609234863948 0.7009598138508425 4.804220558735084e-07 -0.09653817537780066 +1.3294000000000001 0.7009627719750061 0.7009616511570881 4.819439762687727e-07 -0.0965392088176106 +1.3295 0.7009646199331063 0.7009634879032278 4.833464926912168e-07 -0.09654024195434432 +1.3296000000000001 0.7009664673595779 0.7009653240906938 4.846293197857676e-07 -0.09654127478808745 +1.3297 0.7009683142532998 0.7009671597209208 4.857921993423053e-07 -0.09654230731892567 +1.3298 0.7009701606131488 0.7009689947953455 4.868349005177075e-07 -0.09654333954694447 +1.3299 0.7009720064379994 0.7009708293154074 4.877572197525826e-07 -0.0965443714722295 +1.33 0.7009738517267247 0.7009726632825475 4.885589808684143e-07 -0.09654540309486624 +1.3301 0.7009756964781954 0.7009744966982079 4.892400350398063e-07 -0.09654643441494025 +1.3302 0.7009775406912817 0.7009763295638329 4.89800260849993e-07 -0.09654746543253712 +1.3303000000000003 0.7009793843648524 0.700978161880867 4.902395643741064e-07 -0.09654849614774227 +1.3304 0.7009812274977751 0.7009799936507554 4.905578790542764e-07 -0.09654952656064114 +1.3305 0.7009830700889177 0.7009818248749438 4.907551658522857e-07 -0.0965505566713192 +1.3306000000000002 0.7009849121371476 0.7009836555548778 4.908314132079372e-07 -0.09655158647986188 +1.3307 0.7009867536413326 0.700985485692003 4.907866369557867e-07 -0.09655261598635452 +1.3308000000000002 0.7009885946003404 0.7009873152877641 4.906208803251433e-07 -0.09655364519088251 +1.3309000000000002 0.7009904350130404 0.7009891443436056 4.903342141898692e-07 -0.09655467409353129 +1.331 0.700992274878302 0.70099097286097 4.899267365826576e-07 -0.09655570269438606 +1.3311000000000002 0.7009941141949967 0.7009928008412991 4.893985730280992e-07 -0.09655673099353221 +1.3312 0.7009959529619969 0.7009946282860329 4.887498763622711e-07 -0.09655775899105497 +1.3313000000000001 0.7009977911781777 0.7009964551966094 4.879808267604924e-07 -0.09655878668703967 +1.3314000000000001 0.7009996288424157 0.7009982815744641 4.870916315707907e-07 -0.09655981408157155 +1.3315 0.7010014659535903 0.7010001074210301 4.86082525397169e-07 -0.09656084117473576 +1.3316000000000001 0.7010033025105834 0.7010019327377375 4.849537699608275e-07 -0.0965618679666175 +1.3317 0.7010051385122806 0.7010037575260136 4.837056540585305e-07 -0.09656289445730204 +1.3318 0.7010069739575704 0.701005581787282 4.823384934099506e-07 -0.09656392064687448 +1.3319 0.7010088088453449 0.7010074055229626 4.808526307548133e-07 -0.09656494653541997 +1.332 0.7010106431745 0.7010092287344712 4.792484356169746e-07 -0.09656597212302358 +1.3321 0.7010124769439359 0.7010110514232195 4.775263042072764e-07 -0.09656699740977036 +1.3322 0.7010143101525577 0.7010128735906145 4.756866595345688e-07 -0.09656802239574541 +1.3323000000000003 0.7010161427992747 0.7010146952380585 4.7372995097549886e-07 -0.09656904708103382 +1.3324 0.7010179748830015 0.7010165163669486 4.716566544271661e-07 -0.09657007146572055 +1.3325 0.7010198064026583 0.7010183369786765 4.694672720850779e-07 -0.09657109554989064 +1.3326000000000002 0.70102163735717 0.7010201570746281 4.671623323737606e-07 -0.09657211933362903 +1.3327 0.7010234677454686 0.7010219766561834 4.6474238969695936e-07 -0.09657314281702067 +1.3328000000000002 0.7010252975664916 0.701023795724716 4.62208024444577e-07 -0.09657416600015052 +1.3329000000000002 0.7010271268191826 0.7010256142815932 4.5955984284695717e-07 -0.09657518888310342 +1.333 0.7010289555024927 0.7010274323281751 4.5679847673202323e-07 -0.09657621146596429 +1.3331000000000002 0.7010307836153793 0.7010292498658158 4.5392458345588915e-07 -0.09657723374881803 +1.3332 0.7010326111568077 0.7010310668958608 4.5093884570857057e-07 -0.09657825573174947 +1.3333000000000002 0.7010344381257503 0.7010328834196489 4.4784197139602355e-07 -0.0965792774148434 +1.3334000000000001 0.7010362645211874 0.7010346994385099 4.4463469337646666e-07 -0.09658029879818464 +1.3335 0.7010380903421075 0.7010365149537674 4.4131776945344203e-07 -0.09658131988185807 +1.3336000000000001 0.7010399155875071 0.7010383299667344 4.378919820149929e-07 -0.09658234066594834 +1.3337 0.7010417402563913 0.7010401444787167 4.34358137943458e-07 -0.09658336115054017 +1.3338 0.7010435643477742 0.7010419584910105 4.307170684350603e-07 -0.09658438133571828 +1.3339 0.7010453878606788 0.7010437720049032 4.2696962879174016e-07 -0.09658540122156735 +1.334 0.7010472107941379 0.7010455850216724 4.231166981713552e-07 -0.09658642080817209 +1.3341 0.7010490331471935 0.7010473975425864 4.1915917947665804e-07 -0.0965874400956171 +1.3342 0.7010508549188972 0.7010492095689035 4.1509799907080147e-07 -0.09658845908398699 +1.3343000000000003 0.7010526761083109 0.7010510211018716 4.1093410654835516e-07 -0.09658947777336634 +1.3344 0.7010544967145075 0.7010528321427283 4.0666847461040545e-07 -0.09659049616383977 +1.3345 0.7010563167365695 0.7010546426927005 4.023020987245496e-07 -0.09659151425549183 +1.3346000000000002 0.7010581361735913 0.7010564527530043 3.978359969930567e-07 -0.09659253204840706 +1.3347 0.7010599550246772 0.7010582623248448 3.9327120980592323e-07 -0.09659354954266999 +1.3348000000000002 0.7010617732889433 0.7010600714094153 3.8860879968127815e-07 -0.09659456673836508 +1.3349000000000002 0.7010635909655175 0.7010618800078978 3.8384985106415526e-07 -0.09659558363557683 +1.335 0.7010654080535393 0.7010636881214625 3.7899546988934274e-07 -0.09659660023438969 +1.3351000000000002 0.7010672245521599 0.7010654957512672 3.7404678353281096e-07 -0.09659761653488805 +1.3352 0.7010690404605429 0.7010673028984576 3.690049403884399e-07 -0.09659863253715634 +1.3353000000000002 0.7010708557778644 0.701069109564167 3.638711097569969e-07 -0.09659964824127892 +1.3354000000000001 0.7010726705033128 0.7010709157495152 3.5864648142980293e-07 -0.09660066364734005 +1.3355 0.7010744846360899 0.7010727214556103 3.5333226548056595e-07 -0.09660167875542419 +1.3356000000000001 0.7010762981754104 0.7010745266835468 3.4792969200170276e-07 -0.09660269356561565 +1.3357 0.7010781111205022 0.7010763314344052 3.4244001081290554e-07 -0.09660370807799869 +1.3358 0.7010799234706067 0.701078135709253 3.3686449112807493e-07 -0.09660472229265758 +1.3359 0.7010817352249789 0.7010799395091443 3.3120442129858096e-07 -0.0966057362096766 +1.336 0.7010835463828877 0.7010817428351177 3.2546110851489063e-07 -0.09660674982913986 +1.3361 0.7010853569436164 0.701083545688199 3.1963587846656205e-07 -0.09660776315113162 +1.3362 0.7010871669064626 0.7010853480693997 3.137300751340777e-07 -0.09660877617573616 +1.3363000000000003 0.701088976270738 0.701087149979716 3.0774506033781623e-07 -0.09660978890303754 +1.3364 0.7010907850357692 0.7010889514201297 3.016822135923358e-07 -0.09661080133311997 +1.3365 0.7010925932008976 0.7010907523916072 2.955429316137126e-07 -0.09661181346606747 +1.3366000000000002 0.7010944007654794 0.7010925528951009 2.893286281183127e-07 -0.0966128253019642 +1.3367 0.7010962077288867 0.7010943529315466 2.830407334758478e-07 -0.09661383684089422 +1.3368000000000002 0.7010980140905063 0.7010961525018657 2.7668069434855225e-07 -0.09661484808294164 +1.3369000000000002 0.7010998198497406 0.7010979516069631 2.702499733789332e-07 -0.09661585902819037 +1.337 0.7011016250060081 0.7010997502477283 2.637500488567035e-07 -0.09661686967672446 +1.3371000000000002 0.7011034295587433 0.7011015484250349 2.571824143648982e-07 -0.09661788002862792 +1.3372 0.701105233507396 0.7011033461397402 2.505485784259909e-07 -0.0966188900839847 +1.3373000000000002 0.7011070368514326 0.7011051433926855 2.4385006422433797e-07 -0.09661989984287872 +1.3374000000000001 0.7011088395903361 0.7011069401846952 2.370884091759673e-07 -0.09662090930539391 +1.3375 0.7011106417236057 0.7011087365165777 2.3026516460938895e-07 -0.09662191847161421 +1.3376000000000001 0.7011124432507573 0.701110532389124 2.233818954186506e-07 -0.09662292734162338 +1.3377000000000001 0.7011142441713236 0.7011123278031087 2.1644017967475948e-07 -0.09662393591550539 +1.3378 0.7011160444848541 0.7011141227592896 2.0944160830649317e-07 -0.09662494419334398 +1.3379 0.7011178441909157 0.7011159172584068 2.0238778469100493e-07 -0.09662595217522303 +1.338 0.7011196432890923 0.7011177113011837 1.9528032433116516e-07 -0.09662695986122632 +1.3381 0.7011214417789844 0.7011195048883256 1.8812085443228876e-07 -0.09662796725143759 +1.3382 0.7011232396602112 0.7011212980205213 1.8091101360723227e-07 -0.09662897434594059 +1.3383000000000003 0.7011250369324086 0.7011230906984409 1.7365245141842678e-07 -0.09662998114481906 +1.3384 0.7011268335952303 0.7011248829227373 1.6634682805174994e-07 -0.09663098764815664 +1.3385 0.7011286296483481 0.7011266746940458 1.5899581393488682e-07 -0.09663199385603712 +1.3386000000000002 0.7011304250914511 0.7011284660129828 1.516010893105879e-07 -0.09663299976854399 +1.3387 0.7011322199242467 0.7011302568801481 1.4416434391054112e-07 -0.096634005385761 +1.3388000000000002 0.7011340141464604 0.701132047296122 1.3668727653556867e-07 -0.09663501070777172 +1.3389000000000002 0.7011358077578358 0.7011338372614673 1.2917159469480466e-07 -0.0966360157346598 +1.339 0.7011376007581347 0.7011356267767286 1.2161901416507526e-07 -0.0966370204665088 +1.3391000000000002 0.7011393931471372 0.7011374158424314 1.1403125865783181e-07 -0.09663802490340219 +1.3392 0.701141184924642 0.7011392044590832 1.0641005939240888e-07 -0.09663902904542356 +1.3393000000000002 0.7011429760904658 0.7011409926271729 9.87571547247934e-08 -0.09664003289265638 +1.3394000000000001 0.7011447666444446 0.7011427803471706 9.107428970353548e-08 -0.09664103644518417 +1.3395 0.7011465565864323 0.7011445676195276 8.336321575749817e-08 -0.09664203970309032 +1.3396000000000001 0.7011483459163019 0.7011463544446769 7.562569017544041e-08 -0.0966430426664583 +1.3397000000000001 0.701150134633945 0.7011481408230322 6.786347583019603e-08 -0.09664404533537155 +1.3398 0.7011519227392723 0.7011499267549888 6.007834068427753e-08 -0.09664504770991347 +1.3399 0.7011537102322128 0.7011517122409224 5.2272057442931397e-08 -0.09664604979016739 +1.34 0.701155497112715 0.7011534972811904 4.444640313433501e-08 -0.0966470515762167 +1.3401 0.7011572833807456 0.7011552818761304 3.660315868979358e-08 -0.09664805306814468 +1.3402 0.7011590690362908 0.701157066026062 2.874410855863152e-08 -0.09664905426603468 +1.3403000000000003 0.7011608540793559 0.7011588497312851 2.0871040298797716e-08 -0.09665005516996997 +1.3404 0.7011626385099647 0.7011606329920801 1.2985744150990908e-08 -0.09665105578003377 +1.3405 0.7011644223281606 0.7011624158087089 5.090012667428867e-09 -0.09665205609630942 +1.3406000000000002 0.7011662055340059 0.7011641981814142 -2.8143597270366416e-09 -0.09665305611888006 +1.3407 0.7011679881275819 0.7011659801104191 -1.0725577127834729e-08 -0.0966540558478289 +1.3408000000000002 0.7011697701089892 0.701167761595928 -1.8641842562672206e-08 -0.09665505528323917 +1.3409 0.7011715514783469 0.7011695426381255 -2.6561358396157836e-08 -0.09665605442519394 +1.341 0.7011733322357938 0.7011713232371777 -3.448232674722017e-08 -0.09665705327377637 +1.3411000000000002 0.7011751123814882 0.7011731033932312 -4.240294988386555e-08 -0.09665805182906964 +1.3412 0.7011768919156065 0.7011748831064133 -5.032143064070439e-08 -0.09665905009115677 +1.3413000000000002 0.7011786708383447 0.7011766623768322 -5.823597282314172e-08 -0.09666004806012084 +1.3414000000000001 0.7011804491499183 0.701178441204577 -6.614478161460352e-08 -0.0966610457360449 +1.3415 0.7011822268505608 0.7011802195897173 -7.404606398603991e-08 -0.09666204311901191 +1.3416000000000001 0.7011840039405255 0.7011819975323046 -8.193802909697151e-08 -0.09666304020910499 +1.3417000000000001 0.7011857804200848 0.7011837750323702 -8.98188887077031e-08 -0.09666403700640708 +1.3418 0.7011875562895298 0.7011855520899266 -9.76868575796111e-08 -0.0966650335110011 +1.3419 0.7011893315491704 0.7011873287049676 -1.0554015388453825e-07 -0.09666602972297 +1.342 0.7011911061993357 0.7011891048774679 -1.1337699960117797e-07 -0.09666702564239672 +1.3421 0.7011928802403733 0.7011908806073829 -1.2119562092099967e-07 -0.09666802126936412 +1.3422 0.7011946536726501 0.7011926558946497 -1.2899424865243925e-07 -0.09666901660395506 +1.3423000000000003 0.7011964264965516 0.7011944307391864 -1.3677111862855917e-07 -0.09667001164625247 +1.3424 0.7011981987124815 0.701196205140892 -1.4452447207047303e-07 -0.09667100639633912 +1.3425 0.7011999703208623 0.7011979790996472 -1.522525560366389e-07 -0.09667200085429778 +1.3426000000000002 0.7012017413221356 0.7011997526153139 -1.5995362379062072e-07 -0.09667299502021129 +1.3427 0.7012035117167613 0.7012015256877351 -1.6762593517752333e-07 -0.09667398889416243 +1.3428000000000002 0.7012052815052173 0.7012032983167359 -1.7526775706114273e-07 -0.09667498247623388 +1.3429 0.7012070506880003 0.7012050705021226 -1.828773636795844e-07 -0.09667597576650844 +1.343 0.7012088192656248 0.7012068422436832 -1.9045303705639283e-07 -0.09667696876506876 +1.3431000000000002 0.7012105872386237 0.7012086135411875 -1.9799306738219058e-07 -0.09667796147199748 +1.3432 0.7012123546075484 0.7012103843943871 -2.0549575337550086e-07 -0.09667895388737735 +1.3433000000000002 0.7012141213729675 0.7012121548030158 -2.1295940272336722e-07 -0.09667994601129093 +1.3434000000000001 0.7012158875354677 0.701213924766789 -2.2038233239707328e-07 -0.09668093784382087 +1.3435 0.701217653095654 0.7012156942854044 -2.277628690823541e-07 -0.09668192938504971 +1.3436000000000001 0.7012194180541487 0.7012174633585421 -2.3509934955062706e-07 -0.09668292063506007 +1.3437000000000001 0.7012211824115914 0.7012192319858643 -2.423901209920587e-07 -0.0966839115939345 +1.3438 0.7012229461686394 0.7012210001670163 -2.4963354143536787e-07 -0.09668490226175547 +1.3439 0.7012247093259676 0.7012227679016249 -2.568279800878315e-07 -0.09668589263860551 +1.344 0.7012264718842675 0.7012245351893005 -2.6397181773080147e-07 -0.0966868827245671 +1.3441 0.7012282338442481 0.7012263020296362 -2.710634470493023e-07 -0.09668787251972273 +1.3442 0.7012299952066355 0.7012280684222081 -2.781012730171395e-07 -0.09668886202415483 +1.3443000000000003 0.7012317559721722 0.7012298343665748 -2.8508371324037496e-07 -0.09668985123794582 +1.3444 0.7012335161416173 0.7012315998622791 -2.9200919834937444e-07 -0.09669084016117807 +1.3445 0.7012352757157467 0.7012333649088465 -2.988761723249356e-07 -0.09669182879393397 +1.3446000000000002 0.7012370346953529 0.7012351295057861 -3.056830927966603e-07 -0.09669281713629588 +1.3447 0.7012387930812441 0.7012368936525915 -3.124284315009218e-07 -0.09669380518834614 +1.3448000000000002 0.7012405508742448 0.7012386573487388 -3.191106745306649e-07 -0.09669479295016703 +1.3449 0.701242308075195 0.7012404205936889 -3.257283227239838e-07 -0.0966957804218408 +1.345 0.7012440646849518 0.701242183386887 -3.322798919833114e-07 -0.09669676760344983 +1.3451000000000002 0.7012458207043866 0.7012439457277624 -3.3876391360154745e-07 -0.09669775449507628 +1.3452 0.7012475761343863 0.7012457076157287 -3.4517893459512505e-07 -0.09669874109680242 +1.3453000000000002 0.7012493309758534 0.7012474690501844 -3.515235180509557e-07 -0.09669972740871038 +1.3454000000000002 0.7012510852297058 0.7012492300305129 -3.5779624342480165e-07 -0.09670071343088245 +1.3455 0.7012528388968756 0.7012509905560824 -3.639957068396482e-07 -0.09670169916340067 +1.3456000000000001 0.7012545919783101 0.7012527506262465 -3.701205214812209e-07 -0.09670268460634726 +1.3457000000000001 0.7012563444749709 0.7012545102403436 -3.761693178269687e-07 -0.09670366975980428 +1.3458 0.7012580963878341 0.7012562693976989 -3.8214074394443687e-07 -0.09670465462385386 +1.3459 0.7012598477178897 0.7012580280976222 -3.8803346587290566e-07 -0.09670563919857808 +1.346 0.7012615984661421 0.7012597863394098 -3.9384616785237414e-07 -0.09670662348405898 +1.3461 0.7012633486336092 0.7012615441223438 -3.9957755267744366e-07 -0.09670760748037857 +1.3462 0.7012650982213222 0.7012633014456933 -4.052263418777291e-07 -0.09670859118761889 +1.3463000000000003 0.7012668472303263 0.7012650583087133 -4.107912761480703e-07 -0.09670957460586192 +1.3464 0.7012685956616791 0.7012668147106458 -4.1627111552894336e-07 -0.0967105577351896 +1.3465 0.7012703435164518 0.7012685706507196 -4.216646397048329e-07 -0.09671154057568387 +1.3466000000000002 0.7012720907957279 0.7012703261281512 -4.269706482609714e-07 -0.0967125231274267 +1.3467 0.7012738375006038 0.7012720811421442 -4.3218796106497814e-07 -0.09671350539049997 +1.3468000000000002 0.7012755836321877 0.7012738356918897 -4.373154183431871e-07 -0.09671448736498554 +1.3469 0.7012773291916001 0.7012755897765667 -4.423518810275917e-07 -0.09671546905096527 +1.347 0.7012790741799735 0.7012773433953421 -4.472962310819728e-07 -0.096716450448521 +1.3471000000000002 0.701280818598452 0.7012790965473717 -4.521473716476154e-07 -0.09671743155773456 +1.3472 0.7012825624481911 0.7012808492317992 -4.569042272861701e-07 -0.09671841237868774 +1.3473000000000002 0.701284305730357 0.7012826014477576 -4.615657442988419e-07 -0.09671939291146231 +1.3474000000000002 0.7012860484461274 0.7012843531943681 -4.661308909137407e-07 -0.09672037315613999 +1.3475 0.7012877905966907 0.7012861044707419 -4.705986574524146e-07 -0.09672135311280255 +1.3476000000000001 0.7012895321832451 0.7012878552759794 -4.749680566906722e-07 -0.09672233278153168 +1.3477000000000001 0.701291273207 0.7012896056091702 -4.792381239418497e-07 -0.09672331216240908 +1.3478 0.7012930136691738 0.7012913554693948 -4.834079174037553e-07 -0.09672429125551639 +1.3479 0.7012947535709955 0.7012931048557234 -4.874765181656082e-07 -0.09672527006093529 +1.348 0.7012964929137029 0.7012948537672162 -4.914430306590667e-07 -0.09672624857874737 +1.3481 0.7012982316985432 0.701296602202925 -4.953065826790448e-07 -0.09672722680903423 +1.3482 0.7012999699267728 0.7012983501618917 -4.990663256335126e-07 -0.09672820475187748 +1.3483000000000003 0.7013017075996568 0.7013000976431496 -5.027214347239073e-07 -0.09672918240735862 +1.3484 0.7013034447184684 0.701301844645724 -5.062711091116667e-07 -0.09673015977555921 +1.3485 0.7013051812844895 0.7013035911686314 -5.097145721125185e-07 -0.09673113685656082 +1.3486000000000002 0.7013069172990096 0.7013053372108803 -5.130510714046466e-07 -0.09673211365044486 +1.3487 0.7013086527633259 0.7013070827714716 -5.162798790911416e-07 -0.09673309015729287 +1.3488000000000002 0.7013103876787433 0.7013088278493986 -5.194002919706175e-07 -0.09673406637718623 +1.3489 0.7013121220465737 0.7013105724436473 -5.224116316066008e-07 -0.09673504231020644 +1.349 0.701313855868136 0.7013123165531966 -5.253132445079411e-07 -0.09673601795643488 +1.3491000000000002 0.7013155891447553 0.7013140601770192 -5.281045023022846e-07 -0.09673699331595297 +1.3492 0.7013173218777637 0.7013158033140809 -5.307848018054617e-07 -0.09673796838884202 +1.3493000000000002 0.701319054068499 0.7013175459633414 -5.333535651741439e-07 -0.09673894317518339 +1.3494000000000002 0.7013207857183048 0.7013192881237542 -5.358102401001319e-07 -0.09673991767505839 +1.3495 0.7013225168285306 0.701321029794268 -5.381542997826005e-07 -0.09674089188854836 +1.3496000000000001 0.7013242474005308 0.7013227709738256 -5.403852432056544e-07 -0.09674186581573457 +1.3497000000000001 0.7013259774356649 0.7013245116613643 -5.425025951522056e-07 -0.09674283945669825 +1.3498 0.7013277069352971 0.7013262518558177 -5.445059062664237e-07 -0.09674381281152064 +1.3499 0.7013294359007962 0.7013279915561139 -5.463947533035363e-07 -0.096744785880283 +1.35 0.7013311643335352 0.7013297307611771 -5.481687390118672e-07 -0.0967457586630665 +1.3501 0.7013328922348907 0.7013314694699275 -5.49827492410393e-07 -0.0967467311599523 +1.3502 0.7013346196062427 0.7013332076812818 -5.51370668726292e-07 -0.09674770337102157 +1.3503000000000003 0.7013363464489755 0.7013349453941531 -5.527979495129065e-07 -0.09674867529635543 +1.3504 0.7013380727644751 0.7013366826074512 -5.541090427885198e-07 -0.09674964693603494 +1.3505 0.7013397985541316 0.7013384193200836 -5.553036829114566e-07 -0.09675061829014125 +1.3506000000000002 0.7013415238193369 0.7013401555309545 -5.563816308784553e-07 -0.09675158935875544 +1.3507 0.701343248561485 0.7013418912389665 -5.573426741789511e-07 -0.09675256014195852 +1.3508000000000002 0.7013449727819723 0.7013436264430198 -5.581866269060987e-07 -0.09675353063983153 +1.3509 0.7013466964821959 0.7013453611420131 -5.589133297567717e-07 -0.09675450085245546 +1.351 0.7013484196635555 0.7013470953348435 -5.595226501564632e-07 -0.09675547077991131 +1.3511000000000002 0.7013501423274511 0.7013488290204073 -5.600144821205078e-07 -0.09675644042228004 +1.3512 0.7013518644752832 0.7013505621975991 -5.603887464761259e-07 -0.09675740977964253 +1.3513000000000002 0.7013535861084534 0.7013522948653141 -5.606453906958908e-07 -0.09675837885207976 +1.3514000000000002 0.7013553072283634 0.7013540270224462 -5.607843890365061e-07 -0.09675934763967259 +1.3515 0.7013570278364145 0.70135575866789 -5.608057423583945e-07 -0.09676031614250191 +1.3516000000000001 0.7013587479340082 0.7013574898005401 -5.607094783199873e-07 -0.09676128436064858 +1.3517000000000001 0.7013604675225449 0.7013592204192916 -5.604956512528236e-07 -0.09676225229419345 +1.3518000000000001 0.7013621866034241 0.7013609505230403 -5.601643421337954e-07 -0.09676321994321734 +1.3519 0.7013639051780441 0.7013626801106836 -5.597156586961693e-07 -0.09676418730780097 +1.352 0.7013656232478019 0.70136440918112 -5.591497351659092e-07 -0.09676515438802515 +1.3521 0.7013673408140928 0.7013661377332495 -5.584667323588199e-07 -0.09676612118397063 +1.3522 0.7013690578783097 0.7013678657659745 -5.576668377360594e-07 -0.09676708769571815 +1.3523000000000003 0.701370774441843 0.7013695932781998 -5.567502651682155e-07 -0.09676805392334836 +1.3524 0.7013724905060812 0.7013713202688321 -5.557172549908174e-07 -0.09676901986694203 +1.3525 0.7013742060724093 0.7013730467367811 -5.545680738794356e-07 -0.09676998552657974 +1.3526000000000002 0.701375921142209 0.7013747726809604 -5.53303014849682e-07 -0.09677095090234217 +1.3527 0.7013776357168593 0.7013764981002857 -5.519223971184317e-07 -0.09677191599430994 +1.3528000000000002 0.7013793497977345 0.7013782229936776 -5.50426566055251e-07 -0.09677288080256363 +1.3529 0.7013810633862054 0.7013799473600597 -5.488158930921916e-07 -0.09677384532718382 +1.353 0.7013827764836384 0.7013816711983605 -5.470907756682797e-07 -0.0967748095682511 +1.3531000000000002 0.7013844890913958 0.7013833945075125 -5.452516370907379e-07 -0.09677577352584601 +1.3532 0.7013862012108343 0.7013851172864531 -5.432989263962074e-07 -0.096776737200049 +1.3533000000000002 0.7013879128433056 0.701386839534125 -5.412331183299313e-07 -0.09677770059094061 +1.3534000000000002 0.7013896239901567 0.7013885612494757 -5.390547132000378e-07 -0.09677866369860133 +1.3535 0.7013913346527276 0.7013902824314591 -5.367642367248848e-07 -0.09677962652311156 +1.3536000000000001 0.701393044832354 0.7013920030790342 -5.343622398804038e-07 -0.09678058906455178 +1.3537000000000001 0.7013947545303639 0.7013937231911662 -5.318492988931611e-07 -0.09678155132300234 +1.3538000000000001 0.70139646374808 0.7013954427668273 -5.292260149905581e-07 -0.09678251329854368 +1.3539 0.7013981724868175 0.7013971618049957 -5.264930142689916e-07 -0.09678347499125613 +1.354 0.7013998807478848 0.7013988803046569 -5.236509475967099e-07 -0.09678443640122007 +1.3541 0.7014015885325833 0.701400598264803 -5.207004904611567e-07 -0.09678539752851575 +1.3542 0.7014032958422067 0.7014023156844346 -5.176423427191712e-07 -0.09678635837322358 +1.3543000000000003 0.7014050026780408 0.701404032562559 -5.144772285067822e-07 -0.09678731893542379 +1.3544 0.7014067090413634 0.7014057488981918 -5.112058960657362e-07 -0.09678827921519659 +1.3545 0.7014084149334443 0.7014074646903572 -5.078291175283911e-07 -0.09678923921262231 +1.3546 0.7014101203555441 0.7014091799380873 -5.043476887997556e-07 -0.0967901989277811 +1.3547 0.7014118253089154 0.7014108946404228 -5.007624293146273e-07 -0.09679115836075317 +1.3548000000000002 0.7014135297948012 0.7014126087964144 -4.9707418187106e-07 -0.09679211751161873 +1.3549 0.7014152338144355 0.701414322405121 -4.932838123944405e-07 -0.09679307638045791 +1.355 0.7014169373690424 0.7014160354656112 -4.893922097778947e-07 -0.09679403496735084 +1.3551000000000002 0.7014186404598369 0.7014177479769633 -4.854002856602424e-07 -0.09679499327237766 +1.3552 0.7014203430880233 0.7014194599382656 -4.8130897422477e-07 -0.09679595129561838 +1.3553000000000002 0.7014220452547957 0.7014211713486169 -4.771192319771855e-07 -0.09679690903715317 +1.3554000000000002 0.7014237469613381 0.7014228822071256 -4.7283203750275726e-07 -0.09679786649706201 +1.3555 0.701425448208824 0.7014245925129117 -4.684483912581472e-07 -0.096798823675425 +1.3556000000000001 0.7014271489984151 0.7014263022651053 -4.639693153146718e-07 -0.0967997805723221 +1.3557000000000001 0.7014288493312624 0.701428011462848 -4.593958531431963e-07 -0.0968007371878333 +1.3558000000000001 0.7014305492085053 0.7014297201052926 -4.54729069343518e-07 -0.09680169352203855 +1.3559 0.7014322486312718 0.7014314281916034 -4.499700494778325e-07 -0.09680264957501779 +1.356 0.7014339476006783 0.7014331357209569 -4.451198997237893e-07 -0.096803605346851 +1.3561 0.7014356461178284 0.7014348426925407 -4.401797466385693e-07 -0.09680456083761797 +1.3562 0.701437344183814 0.7014365491055555 -4.3515073692296236e-07 -0.09680551604739872 +1.3563000000000003 0.7014390417997143 0.7014382549592142 -4.300340371507505e-07 -0.09680647097627304 +1.3564 0.701440738966596 0.7014399602527417 -4.2483083347727435e-07 -0.09680742562432078 +1.3565 0.7014424356855125 0.7014416649853767 -4.195423314104496e-07 -0.09680837999162176 +1.3566 0.7014441319575043 0.70144336915637 -4.141697554846391e-07 -0.09680933407825575 +1.3567 0.7014458277835989 0.701445072764986 -4.0871434900391357e-07 -0.09681028788430253 +1.3568000000000002 0.7014475231648096 0.701446775810503 -4.031773737159239e-07 -0.09681124140984187 +1.3569 0.7014492181021367 0.7014484782922122 -3.975601095829173e-07 -0.09681219465495355 +1.357 0.701450912596566 0.7014501802094188 -3.918638544278541e-07 -0.09681314761971715 +1.3571000000000002 0.7014526066490698 0.7014518815614426 -3.8608992369848494e-07 -0.09681410030421246 +1.3572 0.7014543002606058 0.7014535823476165 -3.8023965006489524e-07 -0.09681505270851916 +1.3573000000000002 0.7014559934321175 0.7014552825672886 -3.7431438323215493e-07 -0.09681600483271685 +1.3574000000000002 0.7014576861645334 0.7014569822198213 -3.6831548952398485e-07 -0.0968169566768852 +1.3575 0.7014593784587675 0.7014586813045918 -3.622443516607121e-07 -0.09681790824110381 +1.3576000000000001 0.7014610703157188 0.701460379820992 -3.5610236831518094e-07 -0.09681885952545226 +1.3577000000000001 0.7014627617362711 0.7014620777684287 -3.4989095396703584e-07 -0.0968198105300101 +1.3578000000000001 0.7014644527212928 0.7014637751463244 -3.436115384100602e-07 -0.09682076125485685 +1.3579 0.701466143271637 0.7014654719541167 -3.3726556652319273e-07 -0.0968217117000721 +1.358 0.7014678333881414 0.7014671681912585 -3.30854497909705e-07 -0.09682266186573532 +1.3581 0.7014695230716277 0.7014688638572191 -3.243798065502568e-07 -0.096823611751926 +1.3582 0.7014712123229014 0.7014705589514826 -3.1784298046982906e-07 -0.09682456135872358 +1.3583000000000003 0.7014729011427526 0.7014722534735501 -3.112455214393517e-07 -0.09682551068620754 +1.3584 0.7014745895319547 0.7014739474229382 -3.045889445246752e-07 -0.09682645973445728 +1.3585 0.7014762774912648 0.7014756407991798 -2.978747778575874e-07 -0.09682740850355216 +1.3586 0.7014779650214237 0.7014773336018245 -2.9110456220907133e-07 -0.0968283569935716 +1.3587 0.7014796521231554 0.7014790258304382 -2.842798506874633e-07 -0.09682930520459494 +1.3588000000000002 0.7014813387971675 0.7014807174846035 -2.7740220833599727e-07 -0.09683025313670153 +1.3589 0.7014830250441505 0.7014824085639197 -2.7047321180320716e-07 -0.09683120078997068 +1.359 0.7014847108647778 0.7014840990680031 -2.634944489543489e-07 -0.09683214816448166 +1.3591000000000002 0.7014863962597061 0.701485788996487 -2.5646751853486416e-07 -0.09683309526031376 +1.3592 0.7014880812295745 0.7014874783490216 -2.493940298303743e-07 -0.09683404207754624 +1.3593000000000002 0.7014897657750049 0.7014891671252745 -2.422756022191219e-07 -0.09683498861625829 +1.3594000000000002 0.7014914498966021 0.7014908553249313 -2.3511386486319008e-07 -0.09683593487652918 +1.3595 0.7014931335949529 0.7014925429476939 -2.2791045630604634e-07 -0.09683688085843807 +1.3596000000000001 0.701494816870627 0.7014942299932821 -2.206670241151898e-07 -0.09683782656206413 +1.3597000000000001 0.7014964997241757 0.7014959164614336 -2.1338522453173692e-07 -0.09683877198748649 +1.3598000000000001 0.7014981821561335 0.7014976023519038 -2.0606672201939347e-07 -0.09683971713478434 +1.3599 0.7014998641670158 0.7014992876644656 -1.98713188934857e-07 -0.09684066200403667 +1.36 0.7015015457573213 0.7015009723989097 -1.9132630515311666e-07 -0.09684160659532265 +1.3601 0.7015032269275296 0.7015026565550454 -1.8390775766846668e-07 -0.09684255090872132 +1.3602 0.7015049076781031 0.7015043401326992 -1.7645924019205061e-07 -0.09684349494431173 +1.3603000000000003 0.7015065880094855 0.7015060231317165 -1.6898245276675272e-07 -0.0968444387021729 +1.3604 0.7015082679221023 0.7015077055519601 -1.6147910144280464e-07 -0.09684538218238385 +1.3605 0.7015099474163611 0.7015093873933114 -1.5395089780073645e-07 -0.09684632538502352 +1.3606 0.7015116264926502 0.7015110686556698 -1.4639955861137088e-07 -0.09684726831017085 +1.3607 0.7015133051513408 0.7015127493389535 -1.3882680544204107e-07 -0.09684821095790483 +1.3608000000000002 0.7015149833927847 0.7015144294430987 -1.3123436424199164e-07 -0.09684915332830436 +1.3609 0.7015166612173158 0.7015161089680599 -1.2362396497635209e-07 -0.09685009542144835 +1.361 0.7015183386252491 0.7015177879138108 -1.1599734120806837e-07 -0.09685103723741571 +1.3611000000000002 0.701520015616881 0.701519466280342 -1.0835622971799852e-07 -0.09685197877628518 +1.3612 0.7015216921924898 0.7015211440676643 -1.0070237010679356e-07 -0.09685292003813567 +1.3613000000000002 0.701523368352335 0.7015228212758062 -9.303750440285002e-08 -0.09685386102304602 +1.3614000000000002 0.7015250440966567 0.7015244979048147 -8.536337665031313e-08 -0.09685480173109498 +1.3615 0.7015267194256776 0.701526173954756 -7.768173252657024e-08 -0.09685574216236131 +1.3616000000000001 0.7015283943396007 0.7015278494257136 -6.999431894499919e-08 -0.09685668231692376 +1.3617000000000001 0.7015300688386112 0.7015295243177911 -6.23028836516451e-08 -0.0968576221948611 +1.3618000000000001 0.701531742922875 0.7015311986311099 -5.46091748286192e-08 -0.09685856179625206 +1.3619 0.7015334165925395 0.7015328723658101 -4.691494070443655e-08 -0.09685950112117529 +1.362 0.7015350898477337 0.7015345455220503 -3.9221929147494495e-08 -0.09686044016970946 +1.3621 0.7015367626885671 0.7015362181000077 -3.153188727321194e-08 -0.09686137894193317 +1.3622 0.7015384351151319 0.7015378900998781 -2.3846561048729287e-08 -0.0968623174379251 +1.3623000000000003 0.7015401071275003 0.701539561521876 -1.6167694895981993e-08 -0.09686325565776382 +1.3624 0.7015417787257269 0.7015412323662344 -8.497031291250512e-09 -0.09686419360152798 +1.3625 0.701543449909847 0.7015429026332047 -8.363103768532776e-10 -0.09686513126929605 +1.3626 0.701545120679878 0.7015445723230568 6.8127304405501965e-09 -0.09686606866114666 +1.3627 0.7015467910358183 0.701546241436079 1.4448356873766888e-08 -0.09686700577715832 +1.3628000000000002 0.7015484609776479 0.7015479099725783 2.2068838163163962e-08 -0.09686794261740948 +1.3629 0.7015501305053284 0.7015495779328793 2.9672447450501682e-08 -0.09686887918197865 +1.363 0.7015517996188033 0.7015512453173258 3.7257462186593426e-08 -0.09686981547094431 +1.3631000000000002 0.7015534683179974 0.7015529121262796 4.482216451814902e-08 -0.09687075148438487 +1.3632 0.701555136602817 0.7015545783601205 5.236484166594446e-08 -0.09687168722237878 +1.3633000000000002 0.7015568044731504 0.7015562440192464 5.988378632554303e-08 -0.09687262268500435 +1.3634000000000002 0.7015584719288681 0.7015579091040738 6.737729704546502e-08 -0.09687355787234009 +1.3635 0.7015601389698224 0.7015595736150366 7.484367861403107e-08 -0.09687449278446429 +1.3636000000000001 0.7015618055958466 0.7015612375525873 8.228124244273605e-08 -0.09687542742145525 +1.3637000000000001 0.7015634718067574 0.7015629009171952 8.968830695829655e-08 -0.09687636178339129 +1.3638000000000001 0.701565137602353 0.7015645637093488 9.706319796867757e-08 -0.09687729587035081 +1.3639000000000001 0.7015668029824136 0.7015662259295535 1.0440424903085388e-07 -0.09687822968241198 +1.364 0.7015684679467019 0.7015678875783324 1.1170980188102142e-07 -0.09687916321965309 +1.3641 0.7015701324949633 0.7015695486562259 1.1897820672082671e-07 -0.09688009648215234 +1.3642 0.701571796626925 0.7015712091637925 1.2620782267880326e-07 -0.09688102946998799 +1.3643000000000003 0.7015734603422974 0.7015728691016077 1.3339701812956073e-07 -0.09688196218323819 +1.3644 0.7015751236407732 0.7015745284702639 1.405441710719546e-07 -0.09688289462198112 +1.3645 0.7015767865220282 0.7015761872703712 1.4764766950725594e-07 -0.09688382678629492 +1.3646 0.7015784489857204 0.7015778455025565 1.5470591177915716e-07 -0.0968847586762577 +1.3647 0.7015801110314921 0.7015795031674634 1.617173069484723e-07 -0.09688569029194766 +1.3648000000000002 0.7015817726589675 0.7015811602657529 1.6868027516783735e-07 -0.0968866216334428 +1.3649 0.7015834338677549 0.7015828167981017 1.7559324800783815e-07 -0.09688755270082126 +1.365 0.7015850946574453 0.7015844727652039 1.8245466882824135e-07 -0.09688848349416102 +1.3651000000000002 0.7015867550276136 0.7015861281677698 1.8926299313881678e-07 -0.09688941401354013 +1.3652 0.701588414977818 0.7015877830065254 1.960166889011794e-07 -0.09689034425903657 +1.3653000000000002 0.7015900745076011 0.7015894372822138 2.0271423694165347e-07 -0.09689127423072835 +1.3654000000000002 0.7015917336164887 0.7015910909955935 2.093541312218894e-07 -0.09689220392869341 +1.3655 0.7015933923039915 0.7015927441474389 2.159348792274418e-07 -0.09689313335300975 +1.3656000000000001 0.7015950505696037 0.7015943967385403 2.2245500230083648e-07 -0.09689406250375526 +1.3657000000000001 0.701596708412804 0.7015960487697033 2.2891303595035106e-07 -0.09689499138100782 +1.3658000000000001 0.7015983658330558 0.7015977002417492 2.3530753015532646e-07 -0.09689591998484537 +1.3659000000000001 0.7016000228298069 0.7015993511555143 2.416370497859699e-07 -0.09689684831534566 +1.366 0.7016016794024904 0.7016010015118501 2.479001748184606e-07 -0.09689777637258662 +1.3661 0.701603335550524 0.7016026513116231 2.540955007374057e-07 -0.09689870415664609 +1.3662 0.7016049912733108 0.7016043005557142 2.602216387925793e-07 -0.09689963166760175 +1.3663000000000003 0.7016066465702392 0.7016059492450193 2.6627721630423373e-07 -0.09690055890553151 +1.3664 0.7016083014406829 0.7016075973804488 2.722608770447388e-07 -0.09690148587051309 +1.3665 0.7016099558840014 0.7016092449629263 2.781712814953208e-07 -0.09690241256262416 +1.3666 0.7016116098995406 0.7016108919933908 2.8400710710974053e-07 -0.0969033389819425 +1.3667 0.7016132634866317 0.7016125384727943 2.897670486820547e-07 -0.0969042651285458 +1.3668000000000002 0.7016149166445924 0.7016141844021028 2.954498185617216e-07 -0.09690519100251171 +1.3669 0.7016165693727269 0.7016158297822956 3.0105414701442346e-07 -0.0969061166039179 +1.367 0.7016182216703264 0.7016174746143655 3.06578782464928e-07 -0.09690704193284204 +1.3671000000000002 0.7016198735366683 0.7016191188993183 3.120224917954606e-07 -0.09690796698936169 +1.3672 0.7016215249710173 0.7016207626381725 3.173840606163214e-07 -0.09690889177355447 +1.3673000000000002 0.7016231759726252 0.7016224058319595 3.2266229350180753e-07 -0.0969098162854979 +1.3674000000000002 0.7016248265407319 0.7016240484817231 3.2785601430246336e-07 -0.0969107405252696 +1.3675 0.7016264766745641 0.7016256905885196 3.3296406639488074e-07 -0.09691166449294712 +1.3676000000000001 0.701628126373337 0.7016273321534167 3.379853129523158e-07 -0.09691258818860789 +1.3677000000000001 0.7016297756362531 0.7016289731774947 3.429186371251003e-07 -0.0969135116123294 +1.3678000000000001 0.7016314244625041 0.7016306136618452 3.47762942394525e-07 -0.0969144347641892 +1.3679000000000001 0.7016330728512699 0.7016322536075712 3.5251715273243445e-07 -0.0969153576442647 +1.368 0.7016347208017186 0.7016338930157868 3.571802129342938e-07 -0.09691628025263332 +1.3681 0.701636368313008 0.7016355318876175 3.617510887440889e-07 -0.09691720258937252 +1.3682 0.7016380153842845 0.701637170224199 3.662287671249431e-07 -0.09691812465455958 +1.3683 0.7016396620146844 0.7016388080266779 3.7061225654361207e-07 -0.09691904644827196 +1.3684 0.7016413082033335 0.7016404452962105 3.7490058710926144e-07 -0.09691996797058695 +1.3685 0.701642953949347 0.7016420820339642 3.790928107885727e-07 -0.09692088922158194 +1.3686 0.7016445992518311 0.701643718241115 3.831880016832989e-07 -0.0969218102013342 +1.3687 0.7016462441098814 0.7016453539188494 3.87185256203737e-07 -0.09692273090992098 +1.3688000000000002 0.701647888522585 0.7016469890683625 3.9108369324220016e-07 -0.09692365134741959 +1.3689 0.7016495324890191 0.7016486236908596 3.9488245435342906e-07 -0.09692457151390729 +1.369 0.7016511760082524 0.7016502577875534 3.9858070400439205e-07 -0.09692549140946127 +1.3691000000000002 0.7016528190793447 0.7016518913596659 4.021776297546964e-07 -0.09692641103415874 +1.3692 0.7016544617013476 0.7016535244084279 4.0567244240230504e-07 -0.09692733038807685 +1.3693000000000002 0.701656103873304 0.7016551569350774 4.090643760945589e-07 -0.09692824947129279 +1.3694000000000002 0.7016577455942496 0.701656788940861 4.1235268866818275e-07 -0.0969291682838837 +1.3695 0.7016593868632122 0.7016584204270329 4.1553666162846836e-07 -0.09693008682592674 +1.3696000000000002 0.7016610276792117 0.7016600513948534 4.1861560039907486e-07 -0.09693100509749897 +1.3697000000000001 0.7016626680412614 0.7016616818455919 4.215888345024399e-07 -0.09693192309867746 +1.3698000000000001 0.7016643079483675 0.7016633117805229 4.244557176083519e-07 -0.0969328408295393 +1.3699000000000001 0.7016659473995297 0.7016649412009284 4.2721562776987243e-07 -0.09693375829016154 +1.37 0.7016675863937409 0.7016665701080964 4.2986796752741974e-07 -0.09693467548062121 +1.3701 0.7016692249299883 0.7016681985033209 4.3241216395734083e-07 -0.09693559240099525 +1.3702 0.7016708630072527 0.7016698263879018 4.3484766894252846e-07 -0.09693650905136064 +1.3703 0.70167250062451 0.7016714537631444 4.3717395918629887e-07 -0.09693742543179437 +1.3704 0.7016741377807306 0.7016730806303593 4.3939053635116965e-07 -0.09693834154237335 +1.3705 0.7016757744748797 0.7016747069908622 4.4149692719763767e-07 -0.09693925738317455 +1.3706 0.7016774107059176 0.7016763328459734 4.4349268357030125e-07 -0.09694017295427486 +1.3707 0.7016790464728002 0.7016779581970178 4.4537738265459925e-07 -0.0969410882557511 +1.3708000000000002 0.7016806817744792 0.7016795830453243 4.4715062698374997e-07 -0.0969420032876802 +1.3709 0.7016823166099022 0.7016812073922254 4.4881204450814005e-07 -0.09694291805013891 +1.371 0.7016839509780132 0.7016828312390577 4.5036128867165237e-07 -0.09694383254320409 +1.3711000000000002 0.7016855848777527 0.7016844545871612 4.5179803855738276e-07 -0.09694474676695256 +1.3712 0.701687218308058 0.7016860774378789 4.531219988390678e-07 -0.09694566072146107 +1.3713000000000002 0.7016888512678638 0.7016876997925561 4.5433289996149595e-07 -0.09694657440680637 +1.3714000000000002 0.7016904837561018 0.7016893216525414 4.55430498057241e-07 -0.09694748782306518 +1.3715 0.7016921157717017 0.7016909430191852 4.5641457517564543e-07 -0.09694840097031426 +1.3716000000000002 0.7016937473135907 0.70169256389384 4.572849391856759e-07 -0.0969493138486303 +1.3717000000000001 0.7016953783806945 0.7016941842778599 4.580414237481678e-07 -0.09695022645808989 +1.3718000000000001 0.7016970089719377 0.7016958041726005 4.586838886141975e-07 -0.09695113879876976 +1.3719000000000001 0.701698639086243 0.7016974235794187 4.5921221937528234e-07 -0.09695205087074654 +1.372 0.7017002687225322 0.7016990424996723 4.5962632762991396e-07 -0.09695296267409681 +1.3721 0.7017018978797267 0.7017006609347193 4.599261509696806e-07 -0.09695387420889717 +1.3722 0.7017035265567476 0.7017022788859182 4.601116529306948e-07 -0.09695478547522418 +1.3723 0.7017051547525156 0.701703896354628 4.60182823083799e-07 -0.09695569647315444 +1.3724 0.7017067824659515 0.701705513342207 4.6013967697905445e-07 -0.09695660720276444 +1.3725 0.7017084096959769 0.701707129850013 4.599822560971689e-07 -0.0969575176641307 +1.3726 0.7017100364415139 0.7017087458794032 4.59710627960519e-07 -0.09695842785732972 +1.3727 0.7017116627014852 0.7017103614317334 4.593248859666166e-07 -0.09695933778243791 +1.3728000000000002 0.7017132884748154 0.7017119765083584 4.588251494158646e-07 -0.09696024743953176 +1.3729 0.7017149137604306 0.7017135911106316 4.582115635323736e-07 -0.09696115682868776 +1.373 0.701716538557258 0.701715205239904 4.5748429933906154e-07 -0.09696206594998226 +1.3731000000000002 0.7017181628642277 0.7017168188975247 4.566435536298985e-07 -0.09696297480349167 +1.3732 0.7017197866802718 0.7017184320848402 4.5568954897684533e-07 -0.09696388338929231 +1.3733000000000002 0.7017214100043248 0.7017200448031943 4.5462253361189253e-07 -0.09696479170746054 +1.3734000000000002 0.7017230328353243 0.701721657053928 4.534427814062436e-07 -0.09696569975807269 +1.3735 0.7017246551722117 0.701723268838379 4.5215059175235384e-07 -0.09696660754120508 +1.3736000000000002 0.701726277013931 0.7017248801578815 4.50746289515358e-07 -0.09696751505693404 +1.3737000000000001 0.7017278983594301 0.7017264910137662 4.492302249567426e-07 -0.09696842230533581 +1.3738000000000001 0.7017295192076609 0.7017281014073586 4.4760277365801793e-07 -0.09696932928648662 +1.3739000000000001 0.70173113955758 0.701729711339981 4.45864336402757e-07 -0.09697023600046267 +1.374 0.7017327594081482 0.7017313208129508 4.44015339079451e-07 -0.0969711424473402 +1.3741 0.701734378758331 0.7017329298275801 4.4205623261905913e-07 -0.09697204862719544 +1.3742 0.7017359976070987 0.7017345383851765 4.399874928076586e-07 -0.09697295454010442 +1.3743 0.7017376159534278 0.7017361464870422 4.3780962026562786e-07 -0.09697386018614346 +1.3744 0.7017392337962995 0.7017377541344731 4.355231402394799e-07 -0.09697476556538859 +1.3745 0.7017408511347015 0.7017393613287596 4.33128602546351e-07 -0.09697567067791592 +1.3746 0.7017424679676271 0.7017409680711856 4.3062658141440613e-07 -0.09697657552380151 +1.3747 0.7017440842940761 0.7017425743630291 4.2801767532324453e-07 -0.09697748010312146 +1.3748000000000002 0.7017457001130553 0.701744180205561 4.253025068998162e-07 -0.0969783844159518 +1.3749 0.7017473154235778 0.7017457856000453 4.2248172272413287e-07 -0.09697928846236858 +1.375 0.7017489302246644 0.7017473905477385 4.1955599326681803e-07 -0.09698019224244774 +1.3751000000000002 0.7017505445153431 0.7017489950498906 4.165260125976733e-07 -0.09698109575626535 +1.3752 0.7017521582946491 0.701750599107743 4.1339249832322844e-07 -0.09698199900389731 +1.3753000000000002 0.701753771561626 0.7017522027225293 4.101561914063301e-07 -0.09698290198541959 +1.3754000000000002 0.7017553843153255 0.7017538058954749 4.0681785593715825e-07 -0.09698380470090812 +1.3755 0.7017569965548072 0.701755408627797 4.0337827900138734e-07 -0.09698470715043878 +1.3756000000000002 0.70175860827914 0.7017570109207039 3.9983827049283605e-07 -0.09698560933408747 +1.3757000000000001 0.7017602194874013 0.7017586127753948 3.961986629053005e-07 -0.09698651125193003 +1.3758000000000001 0.7017618301786774 0.7017602141930601 3.924603111382652e-07 -0.09698741290404231 +1.3759000000000001 0.7017634403520643 0.7017618151748803 3.886240922817974e-07 -0.09698831429050012 +1.376 0.7017650500066677 0.7017634157220275 3.846909054638914e-07 -0.09698921541137938 +1.3761 0.7017666591416023 0.701765015835662 3.8066167160066833e-07 -0.09699011626675573 +1.3762 0.7017682677559938 0.7017666155169351 3.765373331535149e-07 -0.09699101685670494 +1.3763 0.7017698758489775 0.7017682147669881 3.723188540111222e-07 -0.09699191718130286 +1.3764 0.7017714834196995 0.7017698135869508 3.6800721916335766e-07 -0.09699281724062508 +1.3765 0.7017730904673165 0.7017714119779428 3.636034344792205e-07 -0.09699371703474736 +1.3766 0.7017746969909961 0.7017730099410726 3.5910852653336933e-07 -0.0969946165637454 +1.3767 0.7017763029899173 0.7017746074774376 3.5452354231468863e-07 -0.09699551582769483 +1.3768000000000002 0.70177790846327 0.7017762045881235 3.498495490250608e-07 -0.09699641482667132 +1.3769 0.7017795134102561 0.7017778012742046 3.4508763377405494e-07 -0.09699731356075048 +1.377 0.701781117830089 0.7017793975367428 3.402389033638209e-07 -0.09699821203000784 +1.3771000000000002 0.7017827217219943 0.7017809933767885 3.3530448404622826e-07 -0.09699911023451903 +1.3772 0.7017843250852098 0.7017825887953801 3.302855212591882e-07 -0.09700000817435972 +1.3773000000000002 0.7017859279189855 0.7017841837935426 3.2518317930052554e-07 -0.09700090584960533 +1.3774000000000002 0.7017875302225842 0.7017857783722891 3.199986411475675e-07 -0.0970018032603314 +1.3775 0.7017891319952813 0.7017873725326194 3.147331080685656e-07 -0.09700270040661343 +1.3776000000000002 0.7017907332363653 0.7017889662755207 3.093877994839178e-07 -0.09700359728852698 +1.3777000000000001 0.7017923339451378 0.7017905596019661 3.0396395259146836e-07 -0.09700449390614738 +1.3778000000000001 0.7017939341209136 0.7017921525129163 2.984628221236463e-07 -0.0970053902595501 +1.3779000000000001 0.7017955337630216 0.7017937450093175 2.9288567999358195e-07 -0.0970062863488106 +1.378 0.7017971328708039 0.7017953370921028 2.87233815100818e-07 -0.09700718217400428 +1.3781 0.7017987314436165 0.7017969287621911 2.815085329149758e-07 -0.09700807773520648 +1.3782 0.7018003294808299 0.701798520020487 2.7571115529534396e-07 -0.0970089730324926 +1.3783 0.7018019269818282 0.7018001108678806 2.6984302011617833e-07 -0.09700986806593791 +1.3784 0.7018035239460109 0.7018017013052482 2.6390548093363497e-07 -0.09701076283561788 +1.3785 0.7018051203727911 0.7018032913334508 2.5789990676372554e-07 -0.09701165734160766 +1.3786 0.7018067162615971 0.7018048809533346 2.518276816729226e-07 -0.09701255158398261 +1.3787 0.7018083116118716 0.7018064701657314 2.4569020451448154e-07 -0.09701344556281793 +1.3788000000000002 0.7018099064230732 0.7018080589714573 2.394888885745572e-07 -0.09701433927818888 +1.3789 0.7018115006946752 0.7018096473713133 2.3322516129464788e-07 -0.09701523273017071 +1.379 0.7018130944261662 0.7018112353660855 2.269004639177119e-07 -0.09701612591883864 +1.3791000000000002 0.7018146876170506 0.7018128229565436 2.205162511134673e-07 -0.09701701884426783 +1.3792 0.7018162802668477 0.7018144101434419 2.1407399073553046e-07 -0.09701791150653342 +1.3793000000000002 0.7018178723750933 0.7018159969275188 2.075751633807965e-07 -0.0970188039057105 +1.3794000000000002 0.7018194639413391 0.7018175833094972 2.010212621465779e-07 -0.09701969604187426 +1.3795 0.7018210549651521 0.7018191692900833 1.9441379221774024e-07 -0.09702058791509977 +1.3796000000000002 0.7018226454461163 0.7018207548699673 1.8775427052669658e-07 -0.0970214795254621 +1.3797000000000001 0.7018242353838315 0.7018223400498234 1.810442254515654e-07 -0.09702237087303636 +1.3798000000000001 0.7018258247779139 0.7018239248303088 1.7428519644147045e-07 -0.09702326195789752 +1.3799000000000001 0.7018274136279965 0.7018255092120644 1.6747873365224875e-07 -0.09702415278012072 +1.38 0.7018290019337288 0.7018270931957145 1.6062639759603647e-07 -0.09702504333978086 +1.3801 0.7018305896947766 0.701828676781866 1.5372975877350759e-07 -0.09702593363695296 +1.3802 0.7018321769108231 0.7018302599711096 1.467903973546847e-07 -0.09702682367171195 +1.3803 0.7018337635815677 0.7018318427640188 1.3980990277301375e-07 -0.09702771344413275 +1.3804 0.7018353497067278 0.7018334251611498 1.327898733784194e-07 -0.09702860295429028 +1.3805 0.7018369352860372 0.7018350071630419 1.2573191608342138e-07 -0.09702949220225948 +1.3806 0.7018385203192468 0.7018365887702172 1.186376459606786e-07 -0.0970303811881152 +1.3807 0.7018401048061254 0.70183816998318 1.115086859203307e-07 -0.09703126991193234 +1.3808000000000002 0.7018416887464587 0.7018397508024177 1.0434666631101153e-07 -0.0970321583737857 +1.3809 0.70184327214005 0.7018413312283993 9.715322453127118e-08 -0.0970330465737501 +1.381 0.7018448549867202 0.7018429112615776 8.993000470691737e-08 -0.09703393451190036 +1.3811000000000002 0.7018464372863074 0.7018444909023869 8.267865726080403e-08 -0.09703482218831125 +1.3812 0.7018480190386674 0.7018460701512435 7.540083855374358e-08 -0.09703570960305755 +1.3813000000000002 0.701849600243674 0.7018476490085466 6.809821052888854e-08 -0.09703659675621394 +1.3814000000000002 0.7018511809012187 0.7018492274746773 6.07724403127452e-08 -0.0970374836478552 +1.3815 0.7018527610112106 0.7018508055499987 5.3425199824860825e-08 -0.09703837027805605 +1.3816000000000002 0.7018543405735768 0.7018523832348564 4.605816542220531e-08 -0.0970392566468911 +1.3817000000000002 0.7018559195882621 0.7018539605295776 3.867301749324592e-08 -0.09704014275443508 +1.3818000000000001 0.701857498055229 0.7018555374344715 3.127144008498173e-08 -0.09704102860076252 +1.3819000000000001 0.7018590759744587 0.7018571139498296 2.3855120531712792e-08 -0.09704191418594814 +1.382 0.7018606533459499 0.7018586900759253 1.6425749038706527e-08 -0.09704279951006653 +1.3821 0.7018622301697195 0.7018602658130134 8.985018329181471e-09 -0.09704368457319221 +1.3822 0.701863806445802 0.7018618411613315 1.534623243586164e-09 -0.09704456937539983 +1.3823 0.7018653821742505 0.7018634161210984 -5.923739649846271e-09 -0.09704545391676389 +1.3824 0.701866957355136 0.7018649906925146 -1.338837243413521e-08 -0.0970463381973589 +1.3825 0.7018685319885474 0.7018665648757629 -2.08575762316969e-08 -0.09704722221725937 +1.3826 0.7018701060745919 0.7018681386710077 -2.832965158858572e-08 -0.09704810597653979 +1.3827 0.7018716796133945 0.7018697120783954 -3.580289886524063e-08 -0.09704898947527456 +1.3828000000000003 0.7018732526050987 0.7018712850980542 -4.327561862040117e-08 -0.0970498727135382 +1.3829 0.7018748250498659 0.7018728577300939 -5.0746111999035e-08 -0.09705075569140509 +1.383 0.7018763969478754 0.7018744299746067 -5.821268111755491e-08 -0.09705163840894968 +1.3831000000000002 0.701877968299325 0.7018760018316662 -6.567362944871064e-08 -0.09705252086624634 +1.3832 0.7018795391044299 0.7018775733013279 -7.312726221005844e-08 -0.09705340306336943 +1.3833000000000002 0.7018811093634236 0.7018791443836292 -8.057188674321508e-08 -0.09705428500039322 +1.3834000000000002 0.7018826790765578 0.70188071507859 -8.800581290709791e-08 -0.09705516667739211 +1.3835 0.7018842482441019 0.701882285386211 -9.542735345154096e-08 -0.09705604809444036 +1.3836000000000002 0.7018858168663433 0.7018838553064767 -1.0283482440674035e-07 -0.09705692925161233 +1.3837000000000002 0.7018873849435873 0.7018854248393518 -1.1022654545882193e-07 -0.09705781014898218 +1.3838000000000001 0.7018889524761568 0.7018869939847843 -1.1760084034535823e-07 -0.09705869078662421 +1.3839000000000001 0.7018905194643932 0.7018885627427036 -1.2495603722226245e-07 -0.09705957116461267 +1.384 0.7018920859086546 0.7018901311130221 -1.3229046903935615e-07 -0.09706045128302174 +1.3841 0.7018936518093175 0.7018916990956338 -1.396024739280799e-07 -0.09706133114192561 +1.3842 0.7018952171667758 0.7018932666904147 -1.4689039557792827e-07 -0.0970622107413984 +1.3843 0.701896781981441 0.7018948338972243 -1.5415258360941542e-07 -0.0970630900815143 +1.3844 0.7018983462537418 0.7018964007159032 -1.613873939470406e-07 -0.09706396916234736 +1.3845 0.701899909984125 0.7018979671462755 -1.6859318918531485e-07 -0.09706484798397173 +1.3846 0.701901473173054 0.7018995331881478 -1.7576833896693067e-07 -0.09706572654646153 +1.3847 0.7019030358210101 0.701901098841309 -1.8291122034705398e-07 -0.09706660484989081 +1.3848000000000003 0.701904597928491 0.7019026641055306 -1.9002021817843273e-07 -0.09706748289433359 +1.3849 0.7019061594960125 0.7019042289805677 -1.970937254375249e-07 -0.09706836067986394 +1.385 0.7019077205241069 0.7019057934661577 -2.041301436286891e-07 -0.09706923820655587 +1.3851000000000002 0.7019092810133227 0.7019073575620212 -2.1112788311378194e-07 -0.09707011547448335 +1.3852 0.7019108409642264 0.7019089212678615 -2.1808536350767516e-07 -0.09707099248372031 +1.3853000000000002 0.7019124003774004 0.7019104845833659 -2.25001014000914e-07 -0.09707186923434075 +1.3854000000000002 0.7019139592534442 0.7019120475082044 -2.3187327372400923e-07 -0.09707274572641852 +1.3855 0.7019155175929734 0.7019136100420307 -2.3870059210825967e-07 -0.09707362196002758 +1.3856000000000002 0.7019170753966202 0.7019151721844821 -2.4548142922922733e-07 -0.09707449793524182 +1.3857000000000002 0.7019186326650328 0.7019167339351793 -2.522142561467433e-07 -0.09707537365213509 +1.3858000000000001 0.7019201893988763 0.7019182952937271 -2.5889755525185243e-07 -0.0970762491107813 +1.3859000000000001 0.7019217455988308 0.701919856259714 -2.6552982062763575e-07 -0.09707712431125419 +1.386 0.7019233012655928 0.7019214168327127 -2.72109558378808e-07 -0.09707799925362763 +1.3861 0.7019248563998746 0.7019229770122801 -2.786352869578457e-07 -0.09707887393797543 +1.3862 0.7019264110024036 0.7019245367979574 -2.851055375084621e-07 -0.09707974836437128 +1.3863 0.7019279650739232 0.7019260961892702 -2.9151885418479684e-07 -0.09708062253288896 +1.3864 0.7019295186151923 0.7019276551857281 -2.9787379449142115e-07 -0.09708149644360223 +1.3865 0.7019310716269843 0.7019292137868263 -3.041689296268135e-07 -0.09708237009658473 +1.3866 0.7019326241100882 0.7019307719920447 -3.104028447331597e-07 -0.09708324349191018 +1.3867 0.7019341760653077 0.7019323298008481 -3.165741392988086e-07 -0.09708411662965231 +1.3868000000000003 0.7019357274934613 0.7019338872126865 -3.2268142740460304e-07 -0.09708498950988474 +1.3869 0.7019372783953819 0.7019354442269952 -3.287233381055188e-07 -0.09708586213268106 +1.387 0.7019388287719168 0.7019370008431953 -3.346985156943427e-07 -0.09708673449811492 +1.3871000000000002 0.701940378623928 0.7019385570606932 -3.4060561999310623e-07 -0.0970876066062599 +1.3872 0.7019419279522909 0.7019401128788815 -3.464433266653355e-07 -0.09708847845718961 +1.3873000000000002 0.7019434767578953 0.7019416682971387 -3.522103275560573e-07 -0.09708935005097757 +1.3874000000000002 0.701945025041644 0.7019432233148293 -3.5790533094159915e-07 -0.09709022138769728 +1.3875 0.7019465728044545 0.7019447779313044 -3.6352706178632843e-07 -0.0970910924674223 +1.3876000000000002 0.7019481200472567 0.7019463321459019 -3.6907426208959704e-07 -0.0970919632902261 +1.3877000000000002 0.7019496667709944 0.7019478859579458 -3.7454569116329717e-07 -0.09709283385618218 +1.3878000000000001 0.7019512129766234 0.7019494393667474 -3.799401258747226e-07 -0.09709370416536398 +1.3879000000000001 0.7019527586651138 0.7019509923716054 -3.852563609449411e-07 -0.09709457421784495 +1.388 0.7019543038374464 0.7019525449718055 -3.9049320917777797e-07 -0.09709544401369848 +1.3881000000000001 0.7019558484946159 0.7019540971666208 -3.956495018414552e-07 -0.09709631355299796 +1.3882 0.7019573926376287 0.7019556489553126 -4.007240887379804e-07 -0.09709718283581678 +1.3883 0.7019589362675034 0.7019572003371295 -4.0571583861948035e-07 -0.09709805186222832 +1.3884 0.70196047938527 0.7019587513113088 -4.1062363940330693e-07 -0.09709892063230591 +1.3885 0.7019620219919702 0.7019603018770755 -4.154463983663259e-07 -0.0970997891461228 +1.3886 0.7019635640886575 0.7019618520336441 -4.201830424641062e-07 -0.09710065740375241 +1.3887 0.7019651056763963 0.701963401780217 -4.2483251851827e-07 -0.09710152540526798 +1.3888000000000003 0.7019666467562615 0.7019649511159853 -4.29393793452415e-07 -0.09710239315074262 +1.3889 0.7019681873293397 0.7019665000401304 -4.3386585452803716e-07 -0.09710326064024973 +1.389 0.7019697273967276 0.7019680485518222 -4.3824770961514714e-07 -0.09710412787386248 +1.3891000000000002 0.7019712669595317 0.7019695966502209 -4.425383872894151e-07 -0.09710499485165414 +1.3892 0.7019728060188694 0.7019711443344757 -4.467369372068708e-07 -0.09710586157369777 +1.3893000000000002 0.701974344575867 0.7019726916037268 -4.508424302357428e-07 -0.09710672804006663 +1.3894000000000002 0.7019758826316618 0.7019742384571038 -4.548539586438083e-07 -0.09710759425083382 +1.3895 0.7019774201873987 0.7019757848937278 -4.5877063629962134e-07 -0.09710846020607243 +1.3896000000000002 0.7019789572442334 0.7019773309127098 -4.6259159888761836e-07 -0.0971093259058556 +1.3897 0.7019804938033296 0.7019788765131523 -4.663160041648573e-07 -0.09711019135025642 +1.3898000000000001 0.7019820298658603 0.701980421694149 -4.699430319887732e-07 -0.09711105653934798 +1.3899000000000001 0.701983565433006 0.7019819664547848 -4.734718846641228e-07 -0.09711192147320326 +1.39 0.7019851005059561 0.7019835107941363 -4.769017869984959e-07 -0.09711278615189527 +1.3901000000000001 0.7019866350859081 0.7019850547112727 -4.802319865174209e-07 -0.09711365057549705 +1.3902 0.7019881691740668 0.7019865982052551 -4.834617536655927e-07 -0.09711451474408161 +1.3903 0.7019897027716446 0.7019881412751365 -4.865903818832007e-07 -0.0971153786577219 +1.3904 0.7019912358798615 0.7019896839199629 -4.896171878765454e-07 -0.09711624231649085 +1.3905 0.7019927684999439 0.7019912261387737 -4.925415116319165e-07 -0.0971171057204614 +1.3906 0.701994300633125 0.7019927679306014 -4.953627166376373e-07 -0.09711796886970646 +1.3907 0.7019958322806449 0.7019943092944712 -4.980801900436593e-07 -0.09711883176429889 +1.3908000000000003 0.7019973634437495 0.7019958502294026 -5.006933427378901e-07 -0.09711969440431156 +1.3909 0.7019988941236912 0.7019973907344093 -5.03201609498849e-07 -0.09712055678981737 +1.391 0.7020004243217272 0.7019989308084986 -5.056044491205669e-07 -0.09712141892088905 +1.3911000000000002 0.7020019540391211 0.7020004704506726 -5.079013445444258e-07 -0.09712228079759949 +1.3912 0.7020034832771415 0.7020020096599284 -5.100918028938528e-07 -0.09712314242002153 +1.3913000000000002 0.7020050120370611 0.7020035484352578 -5.12175355689426e-07 -0.09712400378822783 +1.3914000000000002 0.7020065403201585 0.7020050867756477 -5.141515588766299e-07 -0.09712486490229122 +1.3915 0.7020080681277157 0.7020066246800805 -5.16019992943817e-07 -0.09712572576228436 +1.3916000000000002 0.7020095954610193 0.7020081621475345 -5.177802630332295e-07 -0.09712658636827999 +1.3917 0.7020111223213601 0.7020096991769844 -5.194319989687557e-07 -0.09712744672035084 +1.3918000000000001 0.7020126487100318 0.7020112357674008 -5.209748553530735e-07 -0.09712830681856953 +1.3919000000000001 0.7020141746283319 0.7020127719177507 -5.224085116717347e-07 -0.09712916666300872 +1.392 0.7020157000775609 0.7020143076269986 -5.237326723486757e-07 -0.09713002625374104 +1.3921000000000001 0.7020172250590223 0.7020158428941055 -5.249470667462175e-07 -0.09713088559083913 +1.3922 0.702018749574022 0.70201737771803 -5.260514493107826e-07 -0.09713174467437559 +1.3923 0.7020202736238682 0.7020189120977284 -5.270455995590173e-07 -0.09713260350442304 +1.3924 0.7020217972098709 0.7020204460321546 -5.279293221818748e-07 -0.09713346208105392 +1.3925 0.7020233203333421 0.7020219795202611 -5.287024469891044e-07 -0.09713432040434086 +1.3926 0.7020248429955955 0.7020235125609986 -5.293648290272124e-07 -0.09713517847435636 +1.3927 0.7020263651979455 0.7020250451533168 -5.2991634853089e-07 -0.0971360362911729 +1.3928000000000003 0.7020278869417078 0.7020265772961636 -5.30356911075669e-07 -0.09713689385486296 +1.3929 0.7020294082281985 0.7020281089884869 -5.30686447418327e-07 -0.097137751165499 +1.393 0.7020309290587344 0.7020296402292341 -5.309049136079103e-07 -0.09713860822315348 +1.3931000000000002 0.7020324494346324 0.7020311710173521 -5.310122909718551e-07 -0.0971394650278988 +1.3932 0.7020339693572091 0.7020327013517876 -5.310085861298663e-07 -0.09714032157980733 +1.3933000000000002 0.7020354888277806 0.7020342312314884 -5.308938309869782e-07 -0.09714117787895148 +1.3934000000000002 0.7020370078476628 0.7020357606554024 -5.306680826294707e-07 -0.09714203392540363 +1.3935 0.7020385264181702 0.7020372896224785 -5.303314234497702e-07 -0.09714288971923613 +1.3936000000000002 0.7020400445406163 0.7020388181316667 -5.298839610007322e-07 -0.09714374526052125 +1.3937 0.702041562216313 0.7020403461819182 -5.293258280164581e-07 -0.09714460054933134 +1.3938000000000001 0.7020430794465704 0.7020418737721864 -5.286571824053565e-07 -0.09714545558573867 +1.3939000000000001 0.7020445962326973 0.7020434009014261 -5.27878207125243e-07 -0.09714631036981557 +1.394 0.7020461125759991 0.7020449275685945 -5.269891102041568e-07 -0.09714716490163415 +1.3941000000000001 0.7020476284777792 0.7020464537726512 -5.25990124670972e-07 -0.0971480191812667 +1.3942 0.7020491439393384 0.7020479795125589 -5.248815084721303e-07 -0.09714887320878551 +1.3943 0.7020506589619742 0.7020495047872832 -5.236635444369475e-07 -0.0971497269842627 +1.3944 0.7020521735469804 0.7020510295957927 -5.223365402082236e-07 -0.09715058050777042 +1.3945 0.7020536876956478 0.7020525539370592 -5.209008280826488e-07 -0.09715143377938082 +1.3946 0.7020552014092631 0.7020540778100592 -5.193567650385589e-07 -0.0971522867991661 +1.3947 0.7020567146891088 0.7020556012137729 -5.177047325971573e-07 -0.09715313956719829 +1.3948000000000003 0.7020582275364626 0.7020571241471841 -5.159451368225154e-07 -0.09715399208354947 +1.3949 0.7020597399525986 0.7020586466092824 -5.140784079815663e-07 -0.09715484434829176 +1.395 0.7020612519387852 0.7020601685990615 -5.12105000689822e-07 -0.09715569636149723 +1.3951000000000002 0.7020627634962857 0.7020616901155204 -5.100253936685117e-07 -0.09715654812323787 +1.3952 0.702064274626358 0.7020632111576632 -5.078400897098878e-07 -0.09715739963358572 +1.3953000000000002 0.7020657853302545 0.7020647317245001 -5.055496154898753e-07 -0.09715825089261276 +1.3954000000000002 0.7020672956092218 0.7020662518150468 -5.031545214362332e-07 -0.09715910190039095 +1.3955 0.7020688054644998 0.7020677714283249 -5.00655381673043e-07 -0.09715995265699229 +1.3956000000000002 0.7020703148973222 0.702069290563363 -4.980527938541757e-07 -0.09716080316248868 +1.3957 0.7020718239089164 0.7020708092191957 -4.953473789343077e-07 -0.0971616534169521 +1.3958000000000002 0.7020733325005022 0.7020723273948648 -4.925397810925936e-07 -0.09716250342045435 +1.3959000000000001 0.7020748406732926 0.7020738450894191 -4.896306676632767e-07 -0.09716335317306736 +1.396 0.7020763484284933 0.7020753623019147 -4.86620728774867e-07 -0.09716420267486298 +1.3961000000000001 0.7020778557673021 0.7020768790314156 -4.835106773917741e-07 -0.09716505192591311 +1.3962 0.7020793626909088 0.7020783952769931 -4.803012490575687e-07 -0.09716590092628946 +1.3963 0.7020808692004953 0.702079911037727 -4.769932016729372e-07 -0.09716674967606388 +1.3964 0.7020823752972352 0.7020814263127055 -4.7358731538466037e-07 -0.09716759817530822 +1.3965 0.7020838809822929 0.7020829411010248 -4.7008439241214006e-07 -0.09716844642409415 +1.3966 0.7020853862568249 0.7020844554017902 -4.664852567837219e-07 -0.09716929442249346 +1.3967 0.702086891121978 0.7020859692141164 -4.6279075419097815e-07 -0.0971701421705779 +1.3968000000000003 0.7020883955788892 0.7020874825371266 -4.59001751856869e-07 -0.09717098966841912 +1.3969 0.7020898996286872 0.7020889953699538 -4.5511913820961425e-07 -0.09717183691608886 +1.397 0.7020914032724899 0.7020905077117408 -4.5114382273003795e-07 -0.0971726839136587 +1.3971000000000002 0.7020929065114057 0.70209201956164 -4.4707673575727913e-07 -0.09717353066120038 +1.3972 0.7020944093465328 0.7020935309188145 -4.4291882824593065e-07 -0.0971743771587855 +1.3973000000000002 0.7020959117789587 0.7020950417824373 -4.3867107153705565e-07 -0.09717522340648566 +1.3974000000000002 0.7020974138097605 0.7020965521516919 -4.34334457198593e-07 -0.09717606940437246 +1.3975 0.7020989154400044 0.7020980620257727 -4.2990999667147367e-07 -0.09717691515251745 +1.3976000000000002 0.7021004166707454 0.7020995714038855 -4.253987211239041e-07 -0.09717776065099222 +1.3977 0.7021019175030276 0.7021010802852463 -4.2080168126401585e-07 -0.09717860589986826 +1.3978000000000002 0.7021034179378833 0.7021025886690835 -4.1611994692353216e-07 -0.09717945089921712 +1.3979000000000001 0.7021049179763332 0.7021040965546366 -4.113546069536844e-07 -0.09718029564911028 +1.398 0.7021064176193863 0.7021056039411571 -4.065067689407176e-07 -0.09718114014961925 +1.3981000000000001 0.7021079168680391 0.7021071108279082 -4.0157755891445657e-07 -0.0971819844008154 +1.3982 0.7021094157232765 0.7021086172141654 -3.9656812109156725e-07 -0.09718282840277026 +1.3983 0.7021109141860702 0.7021101230992168 -3.9147961770208406e-07 -0.09718367215555515 +1.3984 0.7021124122573797 0.702111628482363 -3.8631322857307637e-07 -0.09718451565924154 +1.3985 0.7021139099381519 0.7021131333629173 -3.810701509204817e-07 -0.09718535891390082 +1.3986 0.7021154072293203 0.7021146377402057 -3.757515991478777e-07 -0.09718620191960431 +1.3987 0.7021169041318049 0.7021161416135677 -3.7035880445096536e-07 -0.09718704467642336 +1.3988000000000003 0.7021184006465133 0.702117644982356 -3.648930145747076e-07 -0.09718788718442929 +1.3989 0.7021198967743388 0.7021191478459365 -3.5935549353577345e-07 -0.09718872944369343 +1.399 0.7021213925161613 0.702120650203689 -3.5374752133804366e-07 -0.09718957145428704 +1.3991000000000002 0.7021228878728465 0.702122152055007 -3.480703936534213e-07 -0.09719041321628141 +1.3992 0.7021243828452464 0.702123653399298 -3.4232542153039835e-07 -0.09719125472974771 +1.3993000000000002 0.7021258774341987 0.7021251542359839 -3.3651393110956107e-07 -0.09719209599475727 +1.3994000000000002 0.7021273716405267 0.7021266545645002 -3.3063726322807296e-07 -0.09719293701138124 +1.3995 0.7021288654650393 0.7021281543842974 -3.2469677330171365e-07 -0.0971937777796908 +1.3996000000000002 0.7021303589085306 0.7021296536948405 -3.186938308044618e-07 -0.09719461829975712 +1.3997 0.7021318519717801 0.7021311524956091 -3.1262981909502274e-07 -0.0971954585716514 +1.3998000000000002 0.702133344655552 0.7021326507860979 -3.0650613501437274e-07 -0.09719629859544474 +1.3999000000000001 0.7021348369605958 0.7021341485658161 -3.003241885943253e-07 -0.09719713837120823 +1.4 0.7021363288876453 0.7021356458342889 -2.940854027556894e-07 -0.097197977899013 +1.4001000000000001 0.7021378204374196 0.7021371425910559 -2.8779121295785526e-07 -0.09719881717893009 +1.4002000000000001 0.7021393116106216 0.7021386388356728 -2.814430668587886e-07 -0.09719965621103056 +1.4003 0.702140802407939 0.7021401345677105 -2.750424240270666e-07 -0.09720049499538545 +1.4004 0.7021422928300437 0.7021416297867558 -2.685907555186051e-07 -0.09720133353206578 +1.4005 0.7021437828775916 0.7021431244924108 -2.6208954364767556e-07 -0.09720217182114252 +1.4006 0.7021452725512229 0.702144618684294 -2.555402815601626e-07 -0.09720300986268669 +1.4007 0.7021467618515616 0.70214611236204 -2.489444729456003e-07 -0.09720384765676926 +1.4008000000000003 0.7021482507792152 0.7021476055252992 -2.423036316624716e-07 -0.09720468520346114 +1.4009 0.7021497393347753 0.7021490981737379 -2.356192814016722e-07 -0.09720552250283321 +1.401 0.7021512275188171 0.7021505903070397 -2.2889295530834075e-07 -0.09720635955495645 +1.4011000000000002 0.7021527153318985 0.7021520819249039 -2.2212619570777248e-07 -0.09720719635990166 +1.4012 0.702154202774562 0.7021535730270465 -2.1532055365786062e-07 -0.09720803291773977 +1.4013000000000002 0.7021556898473328 0.7021550636132 -2.0847758865766286e-07 -0.0972088692285416 +1.4014000000000002 0.7021571765507194 0.7021565536831138 -2.0159886827270102e-07 -0.09720970529237802 +1.4015 0.7021586628852137 0.702158043236554 -1.9468596773944413e-07 -0.09721054110931979 +1.4016000000000002 0.70216014885129 0.7021595322733034 -1.8774046969122216e-07 -0.09721137667943769 +1.4017 0.7021616344494059 0.702161020793162 -1.8076396370372838e-07 -0.0972122120028025 +1.4018000000000002 0.7021631196800026 0.7021625087959467 -1.73758045965422e-07 -0.09721304707948497 +1.4019000000000001 0.7021646045435033 0.7021639962814914 -1.6672431896354312e-07 -0.09721388190955586 +1.402 0.7021660890403141 0.702165483249647 -1.5966439103308472e-07 -0.09721471649308581 +1.4021000000000001 0.7021675731708241 0.7021669697002819 -1.5257987603066459e-07 -0.09721555083014555 +1.4022000000000001 0.7021690569354058 0.7021684556332818 -1.454723929702334e-07 -0.09721638492080581 +1.4023 0.7021705403344125 0.7021699410485489 -1.383435656501092e-07 -0.09721721876513713 +1.4024 0.7021720233681819 0.7021714259460039 -1.3119502226439927e-07 -0.09721805236321024 +1.4025 0.7021735060370332 0.7021729103255842 -1.2402839506819863e-07 -0.09721888571509574 +1.4026 0.7021749883412686 0.7021743941872443 -1.1684531996299097e-07 -0.09721971882086416 +1.4027 0.7021764702811726 0.702175877530957 -1.0964743614103045e-07 -0.09722055168058619 +1.4028000000000003 0.7021779518570117 0.7021773603567121 -1.0243638573492753e-07 -0.0972213842943323 +1.4029 0.7021794330690359 0.702178842664517 -9.521381339177432e-08 -0.09722221666217305 +1.403 0.7021809139174764 0.7021803244543966 -8.798136594354716e-08 -0.097223048784179 +1.4031000000000002 0.7021823944025477 0.7021818057263932 -8.074069201245704e-08 -0.0972238806604206 +1.4032 0.7021838745244462 0.7021832864805673 -7.349344164318816e-08 -0.09722471229096841 +1.4033000000000002 0.7021853542833506 0.702184766716996 -6.624126591215154e-08 -0.09722554367589283 +1.4034 0.7021868336794223 0.7021862464357751 -5.8985816567963534e-08 -0.09722637481526436 +1.4035 0.7021883127128044 0.7021877256370166 -5.172874564937299e-08 -0.09722720570915334 +1.4036000000000002 0.702189791383623 0.7021892043208515 -4.447170510709156e-08 -0.09722803635763023 +1.4037 0.7021912696919863 0.7021906824874273 -3.7216346427765236e-08 -0.09722886676076539 +1.4038000000000002 0.7021927476379849 0.7021921601369101 -2.996432026114437e-08 -0.09722969691862926 +1.4039000000000001 0.7021942252216915 0.7021936372694828 -2.271727604554602e-08 -0.09723052683129213 +1.404 0.7021957024431617 0.702195113885346 -1.5476861625618454e-08 -0.09723135649882435 +1.4041000000000001 0.7021971793024329 0.7021965899847177 -8.244722887913725e-09 -0.09723218592129623 +1.4042000000000001 0.7021986557995251 0.7021980655678339 -1.0225033788419102e-09 -0.09723301509877803 +1.4043 0.7022001319344414 0.7021995406349475 6.188156065692341e-09 -0.0972338440313401 +1.4044 0.7022016077071667 0.7022010151863289 1.338561768891855e-08 -0.09723467271905263 +1.4045 0.7022030831176687 0.7022024892222665 2.056824719397221e-08 -0.09723550116198588 +1.4046 0.7022045581658973 0.7022039627430654 2.7734414114258255e-08 -0.0972363293602101 +1.4047 0.7022060328517858 0.7022054357490484 3.488249217080408e-08 -0.09723715731379551 +1.4048000000000003 0.7022075071752495 0.7022069082405548 4.201085965042928e-08 -0.09723798502281215 +1.4049 0.7022089811361865 0.7022083802179424 4.911789977871117e-08 -0.09723881248733032 +1.405 0.7022104547344776 0.7022098516815851 5.620200108601148e-08 -0.09723963970742015 +1.4051000000000002 0.702211927969987 0.7022113226318744 6.326155775268627e-08 -0.09724046668315167 +1.4052 0.7022134008425612 0.7022127930692185 7.02949699941946e-08 -0.09724129341459507 +1.4053000000000002 0.7022148733520299 0.702214262994043 7.730064442712514e-08 -0.09724211990182044 +1.4054 0.7022163454982062 0.7022157324067899 8.427699441093672e-08 -0.09724294614489781 +1.4055 0.7022178172808855 0.7022172013079182 9.122244042092387e-08 -0.09724377214389723 +1.4056000000000002 0.7022192886998471 0.7022186696979038 9.813541039169205e-08 -0.09724459789888878 +1.4057 0.7022207597548532 0.7022201375772388 1.0501434010226629e-07 -0.09724542340994237 +1.4058000000000002 0.7022222304456497 0.7022216049464324 1.1185767348834141e-07 -0.09724624867712808 +1.4059000000000001 0.7022237007719656 0.7022230718060101 1.1866386302739063e-07 -0.09724707370051587 +1.406 0.7022251707335139 0.7022245381565133 1.2543137007173244e-07 -0.09724789848017568 +1.4061000000000001 0.7022266403299908 0.7022260039985004 1.3215866521629205e-07 -0.09724872301617743 +1.4062000000000001 0.7022281095610765 0.7022274693325458 1.3884422862472934e-07 -0.09724954730859107 +1.4063 0.7022295784264352 0.7022289341592394 1.4548655037638358e-07 -0.09725037135748649 +1.4064 0.7022310469257145 0.7022303984791876 1.520841308097487e-07 -0.09725119516293354 +1.4065 0.7022325150585464 0.7022318622930124 1.5863548085554013e-07 -0.0972520187250021 +1.4066 0.702233982824548 0.7022333256013518 1.651391223767007e-07 -0.09725284204376201 +1.4067 0.7022354502233192 0.702234788404859 1.71593588497998e-07 -0.09725366511928313 +1.4068000000000003 0.7022369172544454 0.702236250704203 1.779974239807247e-07 -0.0972544879516352 +1.4069 0.7022383839174962 0.7022377125000682 1.8434918544821266e-07 -0.09725531054088804 +1.407 0.7022398502120255 0.7022391737931538 1.90647441829922e-07 -0.09725613288711141 +1.4071000000000002 0.7022413161375732 0.7022406345841747 1.9689077459389415e-07 -0.09725695499037508 +1.4072 0.7022427816936632 0.7022420948738601 2.030777781214521e-07 -0.09725777685074875 +1.4073000000000002 0.7022442468798049 0.7022435546629544 2.0920705999516453e-07 -0.09725859846830219 +1.4074 0.7022457116954925 0.7022450139522165 2.1527724132150428e-07 -0.09725941984310499 +1.4075 0.7022471761402064 0.7022464727424198 2.2128695702922085e-07 -0.09726024097522684 +1.4076000000000002 0.7022486402134119 0.7022479310343522 2.2723485622322404e-07 -0.09726106186473744 +1.4077 0.7022501039145607 0.7022493888288159 2.3311960237887286e-07 -0.09726188251170645 +1.4078000000000002 0.7022515672430896 0.7022508461266271 2.389398737895343e-07 -0.09726270291620347 +1.4079000000000002 0.7022530301984217 0.7022523029286156 2.4469436375046394e-07 -0.09726352307829805 +1.408 0.7022544927799665 0.7022537592356253 2.503817808988118e-07 -0.0972643429980598 +1.4081000000000001 0.7022559549871199 0.702255215048513 2.560008494773003e-07 -0.09726516267555824 +1.4082000000000001 0.7022574168192639 0.7022566703681496 2.615503096811689e-07 -0.09726598211086293 +1.4083 0.7022588782757679 0.7022581251954194 2.670289178385854e-07 -0.09726680130404347 +1.4084 0.7022603393559876 0.7022595795312191 2.7243544682004073e-07 -0.09726762025516927 +1.4085 0.7022618000592661 0.7022610333764584 2.777686861910045e-07 -0.0972684389643099 +1.4086 0.7022632603849333 0.7022624867320596 2.830274425658086e-07 -0.0972692574315347 +1.4087 0.7022647203323071 0.702263939598958 2.8821053980193634e-07 -0.09727007565691323 +1.4088000000000003 0.7022661799006928 0.7022653919781007 2.933168193122726e-07 -0.09727089364051483 +1.4089 0.7022676390893836 0.7022668438704471 2.983451403426596e-07 -0.097271711382409 +1.409 0.7022690978976605 0.7022682952769685 3.032943801870025e-07 -0.09727252888266509 +1.4091000000000002 0.7022705563247926 0.702269746198648 3.081634344578865e-07 -0.09727334614135248 +1.4092 0.7022720143700381 0.7022711966364801 3.129512173086213e-07 -0.09727416315854052 +1.4093000000000002 0.7022734720326428 0.7022726465914708 3.17656661696919e-07 -0.09727497993429857 +1.4094 0.7022749293118418 0.702274096064637 3.2227871960693877e-07 -0.09727579646869583 +1.4095 0.7022763862068594 0.7022755450570068 3.2681636229908717e-07 -0.09727661276180175 +1.4096000000000002 0.7022778427169091 0.7022769935696189 3.312685805598181e-07 -0.09727742881368555 +1.4097 0.7022792988411934 0.7022784416035222 3.35634384895922e-07 -0.09727824462441646 +1.4098000000000002 0.7022807545789048 0.7022798891597766 3.399128057079981e-07 -0.09727906019406381 +1.4099000000000002 0.7022822099292255 0.7022813362394509 3.4410289359576574e-07 -0.0972798755226967 +1.41 0.702283664891328 0.7022827828436251 3.4820371952459794e-07 -0.09728069061038441 +1.4101000000000001 0.7022851194643747 0.702284228973388 3.522143750614437e-07 -0.09728150545719613 +1.4102000000000001 0.702286573647519 0.702285674629838 3.561339724997281e-07 -0.09728232006320103 +1.4103 0.7022880274399047 0.7022871198140829 3.599616451299692e-07 -0.0972831344284682 +1.4104 0.7022894808406666 0.7022885645272391 3.636965474063114e-07 -0.09728394855306685 +1.4105 0.7022909338489307 0.7022900087704318 3.6733785514081463e-07 -0.09728476243706603 +1.4106 0.7022923864638143 0.7022914525447952 3.708847656977432e-07 -0.09728557608053483 +1.4107 0.7022938386844266 0.7022928958514709 3.7433649809071046e-07 -0.0972863894835423 +1.4108000000000003 0.7022952905098689 0.7022943386916096 3.7769229326023446e-07 -0.09728720264615759 +1.4109 0.7022967419392343 0.702295781066369 3.809514142125159e-07 -0.09728801556844972 +1.411 0.7022981929716081 0.7022972229769144 3.8411314610270475e-07 -0.09728882825048765 +1.4111000000000002 0.7022996436060684 0.7022986644244189 3.8717679652633397e-07 -0.09728964069234038 +1.4112 0.7023010938416865 0.7023001054100626 3.901416955609527e-07 -0.097290452894077 +1.4113000000000002 0.7023025436775258 0.7023015459350318 3.9300719593959865e-07 -0.0972912648557663 +1.4114 0.702303993112644 0.7023029860005201 3.9577267322427057e-07 -0.09729207657747733 +1.4115 0.7023054421460921 0.7023044256077273 3.984375258961337e-07 -0.097292888059279 +1.4116000000000002 0.7023068907769149 0.7023058647578593 4.0100117552899217e-07 -0.09729369930124022 +1.4117 0.702308339004151 0.7023073034521277 4.034630669072503e-07 -0.0972945103034299 +1.4118000000000002 0.7023097868268335 0.7023087416917498 4.05822668123057e-07 -0.09729532106591687 +1.4119000000000002 0.7023112342439903 0.7023101794779486 4.080794706526336e-07 -0.09729613158877001 +1.412 0.7023126812546436 0.7023116168119516 4.10232989613013e-07 -0.0972969418720581 +1.4121000000000001 0.7023141278578113 0.7023130536949913 4.122827636787729e-07 -0.09729775191585 +1.4122000000000001 0.7023155740525062 0.7023144901283054 4.142283553248971e-07 -0.0972985617202145 +1.4123 0.7023170198377366 0.7023159261131353 4.1606935082677543e-07 -0.09729937128522037 +1.4124 0.7023184652125071 0.7023173616507268 4.1780536040592064e-07 -0.09730018061093637 +1.4125 0.7023199101758177 0.7023187967423297 4.194360183062962e-07 -0.09730098969743124 +1.4126 0.7023213547266653 0.7023202313891969 4.209609828290106e-07 -0.09730179854477371 +1.4127 0.7023227988640436 0.7023216655925847 4.223799364710956e-07 -0.09730260715303245 +1.4128000000000003 0.7023242425869423 0.7023230993537527 4.2369258589775027e-07 -0.09730341552227612 +1.4129 0.702325685894349 0.7023245326739638 4.248986621158135e-07 -0.09730422365257348 +1.413 0.7023271287852485 0.7023259655544823 4.259979204251918e-07 -0.09730503154399317 +1.4131000000000002 0.7023285712586229 0.7023273979965758 4.269901405090648e-07 -0.09730583919660374 +1.4132 0.7023300133134526 0.7023288300015131 4.278751265171521e-07 -0.09730664661047382 +1.4133000000000002 0.7023314549487156 0.7023302615705656 4.2865270704489644e-07 -0.09730745378567197 +1.4134 0.7023328961633893 0.7023316927050056 4.2932273516815833e-07 -0.09730826072226686 +1.4135 0.7023343369564492 0.7023331234061072 4.2988508852648266e-07 -0.09730906742032702 +1.4136000000000002 0.7023357773268692 0.7023345536751446 4.3033966930922096e-07 -0.0973098738799209 +1.4137 0.7023372172736235 0.7023359835133934 4.306864042347147e-07 -0.09731068010111708 +1.4138000000000002 0.7023386567956853 0.7023374129221298 4.309252445849898e-07 -0.09731148608398406 +1.4139000000000002 0.7023400958920272 0.7023388419026296 4.3105616627514554e-07 -0.09731229182859033 +1.414 0.7023415345616222 0.702340270456169 4.3107916975620997e-07 -0.09731309733500432 +1.4141000000000001 0.7023429728034436 0.7023416985840234 4.309942800984068e-07 -0.09731390260329448 +1.4142000000000001 0.7023444106164648 0.7023431262874683 4.308015468454385e-07 -0.09731470763352924 +1.4143000000000001 0.7023458479996605 0.7023445535677779 4.3050104416020307e-07 -0.09731551242577705 +1.4144 0.7023472849520058 0.7023459804262253 4.3009287065132185e-07 -0.0973163169801062 +1.4145 0.7023487214724778 0.702347406864082 4.295771494911005e-07 -0.09731712129658515 +1.4146 0.702350157560055 0.7023488328826186 4.2895402824899564e-07 -0.0973179253752822 +1.4147 0.7023515932137174 0.7023502584831031 4.282236789332483e-07 -0.09731872921626572 +1.4148000000000003 0.7023530284324473 0.7023516836668016 4.273862978868004e-07 -0.09731953281960395 +1.4149 0.7023544632152292 0.7023531084349776 4.264421057595391e-07 -0.09732033618536524 +1.415 0.7023558975610505 0.7023545327888923 4.2539134757074715e-07 -0.09732113931361785 +1.4151000000000002 0.7023573314689013 0.7023559567298038 4.242342923968523e-07 -0.09732194220443008 +1.4152 0.7023587649377748 0.7023573802589669 4.229712335032665e-07 -0.09732274485787012 +1.4153000000000002 0.7023601979666677 0.7023588033776329 4.2160248821254687e-07 -0.09732354727400622 +1.4154 0.7023616305545801 0.7023602260870497 4.2012839777255673e-07 -0.09732434945290656 +1.4155 0.7023630627005162 0.702361648388461 4.185493274119767e-07 -0.09732515139463936 +1.4156000000000002 0.7023644944034841 0.7023630702831065 4.1686566609050457e-07 -0.09732595309927278 +1.4157 0.7023659256624966 0.7023644917722212 4.150778264919164e-07 -0.09732675456687495 +1.4158000000000002 0.7023673564765709 0.7023659128570354 4.13186244919983e-07 -0.097327555797514 +1.4159000000000002 0.7023687868447297 0.7023673335387746 4.11191381180509e-07 -0.09732835679125806 +1.416 0.7023702167659996 0.7023687538186587 4.0909371841479913e-07 -0.09732915754817519 +1.4161000000000001 0.7023716462394138 0.7023701736979024 4.068937630996583e-07 -0.09732995806833349 +1.4162000000000001 0.7023730752640106 0.7023715931777151 4.045920448669804e-07 -0.09733075835180095 +1.4163000000000001 0.7023745038388343 0.7023730122592995 4.021891163094593e-07 -0.09733155839864567 +1.4164 0.7023759319629354 0.7023744309438527 3.9968555293895536e-07 -0.09733235820893571 +1.4165 0.7023773596353704 0.702375849232565 3.97081953089351e-07 -0.09733315778273899 +1.4166 0.7023787868552032 0.7023772671266202 3.9437893759042275e-07 -0.09733395712012353 +1.4167 0.7023802136215034 0.7023786846271949 3.9157714980947445e-07 -0.0973347562211573 +1.4168000000000003 0.7023816399333489 0.7023801017354591 3.8867725542929277e-07 -0.09733555508590824 +1.4169 0.7023830657898242 0.7023815184525746 3.8567994226079705e-07 -0.09733635371444425 +1.417 0.7023844911900217 0.7023829347796963 3.8258592013895587e-07 -0.0973371521068333 +1.4171 0.7023859161330408 0.7023843507179709 3.793959206799258e-07 -0.09733795026314321 +1.4172 0.7023873406179904 0.7023857662685369 3.761106971492123e-07 -0.09733874818344189 +1.4173000000000002 0.7023887646439865 0.7023871814325247 3.7273102435758654e-07 -0.0973395458677972 +1.4174 0.7023901882101539 0.7023885962110559 3.6925769832801825e-07 -0.09734034331627694 +1.4175 0.702391611315626 0.7023900106052439 3.656915362262869e-07 -0.09734114052894896 +1.4176000000000002 0.7023930339595454 0.7023914246161922 3.620333761111816e-07 -0.09734193750588103 +1.4177 0.7023944561410639 0.7023928382449958 3.5828407678878404e-07 -0.09734273424714096 +1.4178000000000002 0.7023958778593422 0.7023942514927398 3.544445175765465e-07 -0.0973435307527965 +1.4179000000000002 0.702397299113551 0.7023956643605 3.505155980604302e-07 -0.09734432702291539 +1.418 0.7023987199028705 0.7023970768493424 3.4649823797000545e-07 -0.09734512305756535 +1.4181000000000001 0.7024001402264912 0.7023984889603223 3.42393376887018e-07 -0.09734591885681407 +1.4182000000000001 0.702401560083614 0.7023999006944854 3.3820197405803887e-07 -0.0973467144207293 +1.4183000000000001 0.7024029794734494 0.7024013120528667 3.3392500820711435e-07 -0.09734750974937867 +1.4184 0.7024043983952195 0.70240272303649 3.295634772512712e-07 -0.09734830484282982 +1.4185 0.7024058168481564 0.7024041336463689 3.251183980854111e-07 -0.09734909970115037 +1.4186 0.7024072348315042 0.7024055438835056 3.2059080633944914e-07 -0.09734989432440802 +1.4187 0.7024086523445173 0.7024069537488908 3.15981756121575e-07 -0.09735068871267027 +1.4188000000000003 0.7024100693864622 0.7024083632435041 3.112923198864137e-07 -0.09735148286600476 +1.4189 0.7024114859566165 0.7024097723683131 3.065235879978756e-07 -0.09735227678447904 +1.419 0.70241290205427 0.7024111811242734 3.016766686389505e-07 -0.0973530704681606 +1.4191 0.7024143176787243 0.702412589512329 2.967526874717019e-07 -0.09735386391711703 +1.4192 0.7024157328292933 0.7024139975334114 2.917527874013448e-07 -0.09735465713141582 +1.4193000000000002 0.702417147505303 0.7024154051884395 2.866781282639952e-07 -0.09735545011112443 +1.4194 0.7024185617060925 0.7024168124783199 2.815298866393201e-07 -0.09735624285631037 +1.4195 0.7024199754310131 0.7024182194039462 2.7630925551053176e-07 -0.09735703536704103 +1.4196000000000002 0.7024213886794293 0.7024196259661992 2.7101744406315964e-07 -0.09735782764338395 +1.4197 0.7024228014507179 0.7024210321659464 2.656556773381058e-07 -0.09735861968540642 +1.4198000000000002 0.7024242137442702 0.7024224380040422 2.6022519591939464e-07 -0.0973594114931759 +1.4199000000000002 0.7024256255594898 0.7024238434813275 2.5472725576070054e-07 -0.09736020306675978 +1.42 0.7024270368957946 0.7024252485986293 2.4916312778289207e-07 -0.09736099440622542 +1.4201000000000001 0.7024284477526156 0.7024266533567611 2.435340976658651e-07 -0.0973617855116401 +1.4202000000000001 0.702429858129398 0.7024280577565226 2.3784146543914808e-07 -0.09736257638307119 +1.4203000000000001 0.7024312680256009 0.702429461798699 2.3208654535700202e-07 -0.09736336702058597 +1.4204 0.7024326774406975 0.7024308654840619 2.2627066544045338e-07 -0.09736415742425178 +1.4205 0.7024340863741756 0.7024322688133677 2.2039516723443286e-07 -0.09736494759413583 +1.4206 0.7024354948255372 0.7024336717873592 2.144614054747085e-07 -0.09736573753030542 +1.4207 0.7024369027942989 0.7024350744067638 2.084707478172687e-07 -0.09736652723282775 +1.4208000000000003 0.7024383102799918 0.7024364766722946 2.0242457447056106e-07 -0.09736731670177004 +1.4209 0.7024397172821621 0.7024378785846496 1.963242779040586e-07 -0.09736810593719947 +1.421 0.7024411238003709 0.7024392801445116 1.9017126256376526e-07 -0.09736889493918321 +1.4211 0.7024425298341945 0.7024406813525489 1.8396694447322948e-07 -0.09736968370778848 +1.4212 0.7024439353832244 0.7024420822094136 1.7771275094558003e-07 -0.09737047224308233 +1.4213000000000002 0.7024453404470672 0.7024434827157432 1.7141012027821478e-07 -0.09737126054513201 +1.4214 0.7024467450253451 0.702444882872159 1.6506050139891704e-07 -0.0973720486140045 +1.4215 0.7024481491176959 0.7024462826792675 1.586653535293192e-07 -0.097372836449767 +1.4216000000000002 0.702449552723773 0.7024476821376585 1.522261458587748e-07 -0.0973736240524865 +1.4217 0.7024509558432454 0.7024490812479067 1.4574435718353596e-07 -0.09737441142223004 +1.4218000000000002 0.7024523584757982 0.7024504800105706 1.3922147562225873e-07 -0.09737519855906468 +1.4219000000000002 0.7024537606211324 0.7024518784261929 1.326589982204862e-07 -0.09737598546305745 +1.422 0.702455162278965 0.7024532764952998 1.2605843062105104e-07 -0.09737677213427533 +1.4221000000000001 0.7024565634490292 0.7024546742184015 1.194212867240696e-07 -0.09737755857278525 +1.4222000000000001 0.7024579641310743 0.702456071595992 1.1274908836081399e-07 -0.09737834477865426 +1.4223000000000001 0.702459364324866 0.702457468628549 1.0604336490166455e-07 -0.09737913075194929 +1.4224 0.7024607640301863 0.7024588653165337 9.930565294039018e-08 -0.09737991649273724 +1.4225 0.7024621632468335 0.7024602616603903 9.253749592638694e-08 -0.09738070200108495 +1.4226 0.7024635619746229 0.7024616576605471 8.574044381773338e-08 -0.09738148727705938 +1.4227 0.7024649602133859 0.7024630533174154 7.891605272036806e-08 -0.09738227232072738 +1.4228000000000003 0.7024663579629706 0.7024644486313898 7.206588452900176e-08 -0.09738305713215578 +1.4229 0.7024677552232421 0.7024658436028482 6.519150658884643e-08 -0.09738384171141146 +1.423 0.7024691519940822 0.702467238232152 5.829449131744546e-08 -0.09738462605856123 +1.4231 0.702470548275389 0.7024686325196453 5.137641584558594e-08 -0.09738541017367186 +1.4232 0.7024719440670782 0.702470026465655 4.4438861682497e-08 -0.09738619405681015 +1.4233000000000002 0.7024733393690816 0.7024714200704916 3.748341431859814e-08 -0.09738697770804278 +1.4234 0.7024747341813489 0.7024728133344486 3.051166288549345e-08 -0.09738776112743659 +1.4235 0.7024761285038456 0.7024742062578022 2.3525199781271322e-08 -0.09738854431505825 +1.4236000000000002 0.7024775223365551 0.7024755988408117 1.6525620320957668e-08 -0.09738932727097453 +1.4237 0.7024789156794776 0.702476991083719 9.514522365285105e-09 -0.09739010999525204 +1.4238000000000002 0.7024803085326301 0.7024783829867494 2.4935059520642122e-09 -0.09739089248795746 +1.4239000000000002 0.702481700896047 0.7024797745501108 -4.535827067241038e-09 -0.09739167474915753 +1.424 0.7024830927697796 0.7024811657739938 -1.1571873390070486e-08 -0.09739245677891879 +1.4241000000000001 0.7024844841538962 0.702482556658572 -1.86130286296618e-08 -0.09739323857730789 +1.4242000000000001 0.7024858750484824 0.7024839472040016 -2.565768767890872e-08 -0.09739402014439141 +1.4243000000000001 0.7024872654536408 0.7024853374104224 -3.270424508029085e-08 -0.09739480148023594 +1.4244 0.7024886553694911 0.7024867272779561 -3.975109538940664e-08 -0.09739558258490806 +1.4245 0.7024900447961702 0.7024881168067076 -4.6796633538858734e-08 -0.09739636345847429 +1.4246 0.7024914337338317 0.702489505996765 -5.383925520663878e-08 -0.09739714410100114 +1.4247 0.702492822182647 0.7024908948481985 -6.087735717960618e-08 -0.09739792451255516 +1.4248000000000003 0.7024942101428038 0.7024922833610616 -6.790933771870164e-08 -0.09739870469320279 +1.4249 0.7024955976145075 0.702493671535391 -7.493359692337456e-08 -0.09739948464301058 +1.425 0.7024969845979802 0.7024950593712058 -8.194853709595634e-08 -0.09740026436204494 +1.4251 0.7024983710934605 0.7024964468685082 -8.895256310443439e-08 -0.09740104385037224 +1.4252 0.7024997571012048 0.7024978340272835 -9.594408274891247e-08 -0.09740182310805898 +1.4253000000000002 0.702501142621486 0.7024992208474999 -1.0292150711202486e-07 -0.09740260213517153 +1.4254 0.702502527654594 0.7025006073291089 -1.0988325093667234e-07 -0.0974033809317763 +1.4255 0.7025039122008354 0.7025019934720445 -1.1682773297383431e-07 -0.09740415949793961 +1.4256000000000002 0.7025052962605336 0.7025033792762243 -1.2375337633992178e-07 -0.09740493783372779 +1.4257 0.7025066798340289 0.7025047647415492 -1.306586088888756e-07 -0.09740571593920723 +1.4258000000000002 0.7025080629216782 0.702506149867903 -1.375418635495701e-07 -0.09740649381444422 +1.4259000000000002 0.7025094455238552 0.7025075346551531 -1.444015787083197e-07 -0.09740727145950506 +1.426 0.7025108276409499 0.7025089191031498 -1.5123619853153747e-07 -0.09740804887445596 +1.4261000000000001 0.7025122092733687 0.7025103032117274 -1.5804417334390475e-07 -0.09740882605936323 +1.4262000000000001 0.7025135904215345 0.7025116869807033 -1.6482395995970345e-07 -0.09740960301429305 +1.4263000000000001 0.7025149710858872 0.702513070409879 -1.7157402204190375e-07 -0.09741037973931174 +1.4264000000000001 0.7025163512668822 0.7025144534990387 -1.7829283046472133e-07 -0.09741115623448543 +1.4265 0.7025177309649913 0.7025158362479516 -1.8497886363627591e-07 -0.09741193249988032 +1.4266 0.7025191101807025 0.7025172186563697 -1.9163060785767905e-07 -0.09741270853556258 +1.4267 0.7025204889145198 0.7025186007240294 -1.982465576422232e-07 -0.09741348434159838 +1.4268000000000003 0.7025218671669632 0.7025199824506504 -2.0482521610395987e-07 -0.0974142599180538 +1.4269 0.7025232449385685 0.7025213638359376 -2.113650952456636e-07 -0.09741503526499497 +1.427 0.7025246222298872 0.7025227448795791 -2.1786471633700177e-07 -0.09741581038248799 +1.4271 0.7025259990414865 0.7025241255812481 -2.2432261019555977e-07 -0.09741658527059895 +1.4272 0.7025273753739489 0.7025255059406016 -2.3073731758235794e-07 -0.09741735992939385 +1.4273000000000002 0.7025287512278728 0.7025268859572815 -2.3710738947246845e-07 -0.09741813435893881 +1.4274 0.7025301266038712 0.7025282656309142 -2.4343138745747117e-07 -0.0974189085592998 +1.4275 0.7025315015025728 0.7025296449611107 -2.49707883981376e-07 -0.09741968253054284 +1.4276000000000002 0.7025328759246217 0.7025310239474668 -2.5593546271879264e-07 -0.0974204562727339 +1.4277 0.7025342498706759 0.7025324025895636 -2.6211271888371135e-07 -0.09742122978593895 +1.4278000000000002 0.7025356233414093 0.7025337808869672 -2.682382595417532e-07 -0.09742200307022396 +1.4279000000000002 0.7025369963375101 0.7025351588392289 -2.7431070391201184e-07 -0.09742277612565488 +1.428 0.7025383688596807 0.7025365364458853 -2.803286837244068e-07 -0.09742354895229756 +1.4281000000000001 0.702539740908638 0.7025379137064587 -2.8629084347295275e-07 -0.09742432155021792 +1.4282000000000001 0.7025411124851141 0.7025392906204568 -2.92195840734949e-07 -0.0974250939194819 +1.4283000000000001 0.7025424835898539 0.7025406671873735 -2.9804234651098493e-07 -0.0974258660601553 +1.4284000000000001 0.7025438542236173 0.702542043406688 -3.038290454712711e-07 -0.09742663797230396 +1.4285 0.7025452243871775 0.7025434192778663 -3.095546362921753e-07 -0.09742740965599374 +1.4286 0.7025465940813216 0.7025447948003603 -3.152178319060228e-07 -0.09742818111129042 +1.4287 0.7025479633068499 0.7025461699736079 -3.208173598653885e-07 -0.09742895233825977 +1.4288000000000003 0.7025493320645769 0.7025475447970345 -3.2635196251656895e-07 -0.0974297233369676 +1.4289 0.7025507003553292 0.7025489192700515 -3.318203973881606e-07 -0.09743049410747963 +1.429 0.7025520681799475 0.7025502933920573 -3.372214374131044e-07 -0.09743126464986164 +1.4291 0.7025534355392847 0.7025516671624379 -3.4255387125481374e-07 -0.09743203496417938 +1.4292 0.7025548024342065 0.7025530405805654 -3.4781650346676907e-07 -0.09743280505049844 +1.4293000000000002 0.7025561688655914 0.7025544136458004 -3.530081548949737e-07 -0.09743357490888455 +1.4294 0.7025575348343299 0.7025557863574903 -3.5812766287224296e-07 -0.09743434453940339 +1.4295 0.702558900341325 0.7025571587149708 -3.631738814818819e-07 -0.09743511394212057 +1.4296000000000002 0.7025602653874917 0.7025585307175652 -3.681456818352413e-07 -0.09743588311710176 +1.4297 0.7025616299737565 0.7025599023645853 -3.7304195229376225e-07 -0.09743665206441253 +1.4298000000000002 0.7025629941010576 0.7025612736553306 -3.778615987187761e-07 -0.09743742078411848 +1.4299000000000002 0.7025643577703454 0.7025626445890898 -3.826035447976328e-07 -0.09743818927628527 +1.43 0.7025657209825802 0.7025640151651399 -3.8726673214778407e-07 -0.09743895754097835 +1.4301000000000001 0.7025670837387342 0.7025653853827465 -3.9185012065678926e-07 -0.0974397255782633 +1.4302000000000001 0.7025684460397905 0.702566755241165 -3.9635268866966555e-07 -0.09744049338820565 +1.4303000000000001 0.7025698078867426 0.7025681247396396 -4.007734332386881e-07 -0.09744126097087095 +1.4304000000000001 0.7025711692805943 0.7025694938774038 -4.0511137033155675e-07 -0.09744202832632455 +1.4305 0.70257253022236 0.7025708626536813 -4.093655350395631e-07 -0.09744279545463205 +1.4306 0.7025738907130641 0.7025722310676855 -4.1353498181351256e-07 -0.09744356235585887 +1.4307 0.7025752507537405 0.7025735991186196 -4.17618784706586e-07 -0.09744432903007039 +1.4308 0.7025766103454327 0.7025749668056775 -4.216160374992395e-07 -0.09744509547733202 +1.4309 0.7025779694891943 0.7025763341280438 -4.255258539420659e-07 -0.09744586169770922 +1.431 0.7025793281860873 0.702577701084893 -4.2934736796396145e-07 -0.09744662769126734 +1.4311 0.7025806864371831 0.7025790676753915 -4.330797338525372e-07 -0.09744739345807171 +1.4312 0.7025820442435616 0.7025804338986965 -4.367221264553467e-07 -0.09744815899818775 +1.4313000000000002 0.7025834016063117 0.7025817997539563 -4.4027374130478636e-07 -0.0974489243116807 +1.4314 0.7025847585265301 0.7025831652403116 -4.4373379486095654e-07 -0.09744968939861598 +1.4315 0.7025861150053219 0.702584530356894 -4.471015246781951e-07 -0.0974504542590588 +1.4316000000000002 0.7025874710437996 0.7025858951028281 -4.5037618955079406e-07 -0.0974512188930744 +1.4317 0.7025888266430836 0.70258725947723 -4.5355706967953324e-07 -0.09745198330072809 +1.4318000000000002 0.7025901818043021 0.7025886234792087 -4.5664346681739687e-07 -0.0974527474820851 +1.4319000000000002 0.7025915365285902 0.7025899871078662 -4.5963470449161825e-07 -0.09745351143721065 +1.432 0.7025928908170894 0.7025913503622974 -4.6253012800367976e-07 -0.09745427516617 +1.4321000000000002 0.7025942446709488 0.7025927132415899 -4.653291047068686e-07 -0.09745503866902827 +1.4322000000000001 0.7025955980913228 0.7025940757448255 -4.680310241519936e-07 -0.09745580194585057 +1.4323000000000001 0.7025969510793731 0.702595437871079 -4.7063529815677407e-07 -0.09745656499670209 +1.4324000000000001 0.7025983036362671 0.70259679961942 -4.731413608960455e-07 -0.09745732782164804 +1.4325 0.702599655763178 0.7025981609889116 -4.7554866910992644e-07 -0.09745809042075346 +1.4326 0.7026010074612837 0.7025995219786116 -4.778567022079017e-07 -0.09745885279408345 +1.4327 0.7026023587317687 0.7026008825875727 -4.800649623590281e-07 -0.09745961494170313 +1.4328 0.7026037095758211 0.702602242814842 -4.821729745752013e-07 -0.09746037686367749 +1.4329 0.7026050599946346 0.702603602659462 -4.841802868568723e-07 -0.09746113856007159 +1.433 0.7026064099894076 0.7026049621204706 -4.860864702693757e-07 -0.09746190003095044 +1.4331 0.7026077595613425 0.7026063211969018 -4.878911190678292e-07 -0.09746266127637912 +1.4332 0.7026091087116453 0.7026076798877848 -4.895938507318287e-07 -0.09746342229642253 +1.4333000000000002 0.7026104574415266 0.7026090381921457 -4.911943060556534e-07 -0.09746418309114578 +1.4334 0.7026118057521997 0.7026103961090064 -4.926921492454106e-07 -0.09746494366061373 +1.4335 0.7026131536448819 0.7026117536373857 -4.940870679814857e-07 -0.09746570400489132 +1.4336000000000002 0.7026145011207927 0.702613110776299 -4.9537877349487e-07 -0.09746646412404347 +1.4337 0.7026158481811552 0.7026144675247592 -4.965670005879774e-07 -0.09746722401813504 +1.4338000000000002 0.7026171948271944 0.7026158238817766 -4.976515077526056e-07 -0.09746798368723093 +1.4339000000000002 0.7026185410601381 0.7026171798463592 -4.986320771352415e-07 -0.09746874313139607 +1.434 0.7026198868812156 0.7026185354175131 -4.995085146758393e-07 -0.09746950235069526 +1.4341000000000002 0.7026212322916583 0.7026198905942419 -5.002806500592483e-07 -0.09747026134519332 +1.4342000000000001 0.7026225772926988 0.7026212453755482 -5.009483367776624e-07 -0.09747102011495508 +1.4343000000000001 0.7026239218855717 0.7026225997604331 -5.015114522000097e-07 -0.09747177866004535 +1.4344000000000001 0.7026252660715117 0.7026239537478967 -5.019698974886855e-07 -0.09747253698052888 +1.4345 0.7026266098517545 0.7026253073369382 -5.023235977869023e-07 -0.09747329507647044 +1.4346 0.7026279532275366 0.7026266605265565 -5.02572502024401e-07 -0.0974740529479348 +1.4347 0.7026292962000942 0.7026280133157496 -5.027165830770453e-07 -0.09747481059498662 +1.4348 0.702630638770664 0.7026293657035164 -5.027558377182495e-07 -0.09747556801769065 +1.4349 0.7026319809404822 0.7026307176888553 -5.026902865634675e-07 -0.0974763252161116 +1.435 0.7026333227107844 0.7026320692707653 -5.025199741465203e-07 -0.09747708219031413 +1.4351 0.7026346640828056 0.7026334204482464 -5.022449688640851e-07 -0.09747783894036292 +1.4352 0.7026360050577795 0.702634771220299 -5.018653628993675e-07 -0.09747859546632254 +1.4353000000000002 0.7026373456369384 0.7026361215859254 -5.013812722914901e-07 -0.09747935176825759 +1.4354 0.7026386858215136 0.7026374715441288 -5.007928368314096e-07 -0.09748010784623275 +1.4355 0.7026400256127342 0.702638821093915 -5.001002200688554e-07 -0.0974808637003126 +1.4356000000000002 0.7026413650118273 0.7026401702342906 -4.993036092221237e-07 -0.09748161933056165 +1.4357 0.7026427040200175 0.7026415189642654 -4.984032151642004e-07 -0.09748237473704452 +1.4358000000000002 0.7026440426385271 0.7026428672828509 -4.973992723741882e-07 -0.0974831299198256 +1.4359000000000002 0.7026453808685756 0.7026442151890622 -4.962920388471015e-07 -0.09748388487896953 +1.436 0.7026467187113794 0.702645562681917 -4.950817960314158e-07 -0.09748463961454075 +1.4361000000000002 0.7026480561681516 0.7026469097604362 -4.937688487804959e-07 -0.09748539412660379 +1.4362000000000001 0.7026493932401019 0.7026482564236444 -4.923535252901456e-07 -0.09748614841522313 +1.4363000000000001 0.7026507299284357 0.7026496026705695 -4.908361769667691e-07 -0.09748690248046316 +1.4364000000000001 0.7026520662343544 0.7026509485002441 -4.892171783510424e-07 -0.09748765632238832 +1.4365 0.7026534021590555 0.7026522939117044 -4.874969270693419e-07 -0.09748840994106302 +1.4366 0.7026547377037318 0.7026536389039912 -4.856758437227215e-07 -0.09748916333655162 +1.4367 0.702656072869571 0.7026549834761502 -4.837543717273185e-07 -0.0974899165089185 +1.4368 0.7026574076577564 0.702656327627232 -4.817329772935364e-07 -0.09749066945822803 +1.4369 0.7026587420694654 0.7026576713562924 -4.796121492664507e-07 -0.09749142218454455 +1.437 0.7026600761058706 0.702659014662393 -4.773923989939699e-07 -0.09749217468793242 +1.4371 0.7026614097681378 0.7026603575446004 -4.750742602158131e-07 -0.0974929269684559 +1.4372 0.7026627430574277 0.7026617000019877 -4.726582889941211e-07 -0.0974936790261793 +1.4373000000000002 0.7026640759748942 0.7026630420336337 -4.701450634914117e-07 -0.09749443086116683 +1.4374 0.7026654085216852 0.702664383638624 -4.675351838526187e-07 -0.09749518247348275 +1.4375 0.7026667406989415 0.7026657248160507 -4.648292721357028e-07 -0.09749593386319132 +1.4376000000000002 0.7026680725077976 0.7026670655650129 -4.620279721104237e-07 -0.09749668503035679 +1.4377 0.7026694039493798 0.7026684058846163 -4.591319490154788e-07 -0.09749743597504326 +1.4378000000000002 0.702670735024808 0.7026697457739745 -4.5614188956544233e-07 -0.097498186697315 +1.4379000000000002 0.7026720657351941 0.7026710852322084 -4.5305850169402584e-07 -0.09749893719723617 +1.438 0.702673396081642 0.702672424258447 -4.4988251444999516e-07 -0.09749968747487088 +1.4381000000000002 0.7026747260652481 0.7026737628518266 -4.466146777126756e-07 -0.09750043753028333 +1.4382000000000001 0.7026760556870995 0.702675101011492 -4.4325576209480744e-07 -0.09750118736353751 +1.4383000000000001 0.7026773849482757 0.7026764387365969 -4.398065587898903e-07 -0.09750193697469757 +1.4384000000000001 0.7026787138498474 0.7026777760263032 -4.3626787932932176e-07 -0.0975026863638276 +1.4385 0.7026800423928756 0.7026791128797818 -4.3264055538810853e-07 -0.09750343553099164 +1.4386 0.7026813705784131 0.7026804492962124 -4.2892543863914945e-07 -0.09750418447625375 +1.4387 0.7026826984075031 0.7026817852747846 -4.2512340050343544e-07 -0.09750493319967796 +1.4388 0.7026840258811791 0.7026831208146972 -4.2123533199045493e-07 -0.09750568170132828 +1.4389 0.702685353000464 0.702684455915158 -4.1726214344839363e-07 -0.09750642998126857 +1.439 0.7026866797663727 0.7026857905753859 -4.1320476439066223e-07 -0.09750717803956298 +1.4391 0.7026880061799079 0.7026871247946094 -4.090641432391573e-07 -0.09750792587627537 +1.4392 0.702689332242063 0.7026884585720672 -4.0484124713691116e-07 -0.09750867349146967 +1.4393000000000002 0.7026906579538207 0.7026897919070088 -4.0053706167053615e-07 -0.09750942088520986 +1.4394 0.7026919833161529 0.7026911247986938 -3.961525907245078e-07 -0.09751016805755981 +1.4395 0.7026933083300202 0.7026924572463935 -3.9168885618973137e-07 -0.0975109150085834 +1.4396000000000002 0.7026946329963726 0.7026937892493899 -3.8714689770680266e-07 -0.09751166173834451 +1.4397 0.7026959573161482 0.702695120806976 -3.82527772478658e-07 -0.09751240824690695 +1.4398000000000002 0.7026972812902739 0.7026964519184568 -3.778325549930184e-07 -0.09751315453433457 +1.4399000000000002 0.7026986049196651 0.7026977825831484 -3.7306233680034495e-07 -0.0975139006006912 +1.44 0.7026999282052248 0.7026991128003794 -3.682182262293443e-07 -0.09751464644604065 +1.4401000000000002 0.702701251147844 0.7027004425694896 -3.633013481163516e-07 -0.09751539207044663 +1.4402000000000001 0.7027025737484022 0.7027017718898315 -3.5831284363879723e-07 -0.09751613747397299 +1.4403000000000001 0.7027038960077654 0.7027031007607696 -3.532538698849952e-07 -0.09751688265668335 +1.4404000000000001 0.7027052179267881 0.7027044291816815 -3.481255997084265e-07 -0.09751762761864159 +1.4405 0.7027065395063112 0.702705757151957 -3.429292214779389e-07 -0.09751837235991136 +1.4406 0.7027078607471628 0.7027070846709986 -3.3766593870304673e-07 -0.09751911688055626 +1.4407 0.7027091816501589 0.7027084117382224 -3.3233696983964167e-07 -0.09751986118064013 +1.4408 0.7027105022161011 0.7027097383530568 -3.2694354792917046e-07 -0.0975206052602265 +1.4409 0.7027118224457782 0.7027110645149444 -3.21486920390468e-07 -0.09752134911937908 +1.441 0.7027131423399655 0.7027123902233403 -3.159683487213849e-07 -0.09752209275816145 +1.4411 0.7027144618994242 0.7027137154777142 -3.1038910815184284e-07 -0.09752283617663722 +1.4412 0.7027157811249023 0.7027150402775487 -3.047504874287288e-07 -0.09752357937487 +1.4413000000000002 0.7027171000171335 0.7027163646223409 -2.990537884065003e-07 -0.09752432235292335 +1.4414 0.7027184185768376 0.7027176885116015 -2.9330032583901877e-07 -0.09752506511086084 +1.4415 0.7027197368047198 0.7027190119448556 -2.8749142707076847e-07 -0.09752580764874595 +1.4416000000000002 0.7027210547014715 0.7027203349216424 -2.816284316864426e-07 -0.09752654996664228 +1.4417 0.7027223722677693 0.7027216574415157 -2.7571269125420406e-07 -0.09752729206461329 +1.4418000000000002 0.702723689504275 0.7027229795040438 -2.697455689613937e-07 -0.09752803394272247 +1.4419000000000002 0.7027250064116362 0.7027243011088093 -2.6372843934738266e-07 -0.09752877560103324 +1.442 0.7027263229904852 0.7027256222554104 -2.576626879531585e-07 -0.0975295170396091 +1.4421000000000002 0.7027276392414397 0.702726942943459 -2.5154971100907475e-07 -0.09753025825851351 +1.4422000000000001 0.7027289551651021 0.7027282631725833 -2.4539091513994804e-07 -0.09753099925780984 +1.4423000000000001 0.7027302707620596 0.7027295829424254 -2.3918771700076613e-07 -0.09753174003756149 +1.4424000000000001 0.7027315860328844 0.7027309022526436 -2.3294154297484604e-07 -0.09753248059783183 +1.4425 0.7027329009781331 0.7027322211029108 -2.2665382886505325e-07 -0.09753322093868427 +1.4426 0.702734215598347 0.7027335394929158 -2.2032601951910147e-07 -0.09753396106018218 +1.4427 0.7027355298940513 0.7027348574223624 -2.1395956852424125e-07 -0.09753470096238873 +1.4428 0.7027368438657562 0.7027361748909704 -2.0755593788807092e-07 -0.09753544064536733 +1.4429 0.7027381575139562 0.7027374918984753 -2.0111659766036682e-07 -0.09753618010918132 +1.443 0.7027394708391292 0.702738808444628 -1.9464302562430258e-07 -0.09753691935389391 +1.4431 0.7027407838417383 0.7027401245291955 -1.8813670696338214e-07 -0.09753765837956839 +1.4432 0.7027420965222295 0.7027414401519606 -1.8159913390755622e-07 -0.09753839718626797 +1.4433000000000002 0.7027434088810338 0.7027427553127221 -1.750318054001554e-07 -0.09753913577405592 +1.4434 0.7027447209185653 0.702744070011295 -1.6843622674053704e-07 -0.09753987414299542 +1.4435 0.7027460326352222 0.70274538424751 -1.618139092388754e-07 -0.09754061229314964 +1.4436000000000002 0.7027473440313865 0.7027466980212147 -1.5516636989350296e-07 -0.09754135022458182 +1.4437 0.7027486551074241 0.7027480113322722 -1.4849513102314915e-07 -0.0975420879373551 +1.4438000000000002 0.7027499658636841 0.7027493241805622 -1.4180171993387336e-07 -0.09754282543153257 +1.4439000000000002 0.7027512763004997 0.7027506365659808 -1.3508766853742582e-07 -0.09754356270717744 +1.444 0.7027525864181872 0.7027519484884399 -1.283545130424668e-07 -0.0975442997643527 +1.4441000000000002 0.7027538962170465 0.7027532599478689 -1.2160379357466222e-07 -0.09754503660312148 +1.4442000000000002 0.7027552056973614 0.7027545709442127 -1.1483705383841247e-07 -0.09754577322354689 +1.4443000000000001 0.7027565148593986 0.7027558814774328 -1.0805584075256058e-07 -0.09754650962569193 +1.4444000000000001 0.7027578237034087 0.7027571915475079 -1.0126170410865165e-07 -0.09754724580961965 +1.4445 0.7027591322296254 0.7027585011544326 -9.445619621357981e-08 -0.09754798177539309 +1.4446 0.7027604404382657 0.7027598102982181 -8.764087152529632e-08 -0.0975487175230752 +1.4447 0.7027617483295301 0.7027611189788923 -8.081728631367108e-08 -0.097549453052729 +1.4448 0.7027630559036027 0.7027624271965 -7.398699829793548e-08 -0.09755018836441744 +1.4449 0.7027643631606502 0.7027637349511023 -6.715156628022204e-08 -0.09755092345820353 +1.445 0.7027656701008234 0.7027650422427769 -6.031254980859435e-08 -0.09755165833415011 +1.4451 0.7027669767242559 0.7027663490716183 -5.3471508812104676e-08 -0.09755239299232017 +1.4452 0.7027682830310649 0.7027676554377373 -4.6630003246368214e-08 -0.09755312743277655 +1.4453000000000003 0.7027695890213504 0.7027689613412618 -3.978959273550535e-08 -0.09755386165558215 +1.4454 0.7027708946951967 0.702770266782336 -3.2951836219938593e-08 -0.0975545956607999 +1.4455 0.7027722000526706 0.7027715717611207 -2.611829160044897e-08 -0.09755532944849254 +1.4456000000000002 0.7027735050938224 0.7027728762777932 -1.9290515381690382e-08 -0.09755606301872298 +1.4457 0.7027748098186858 0.7027741803325479 -1.2470062320420194e-08 -0.09755679637155397 +1.4458000000000002 0.7027761142272781 0.7027754839255949 -5.658485069393038e-09 -0.09755752950704831 +1.4459000000000002 0.7027774183196001 0.7027767870571616 1.1426661743543787e-09 -0.09755826242526884 +1.446 0.7027787220956356 0.7027780897274913 7.931844026205781e-09 -0.0975589951262783 +1.4461000000000002 0.702780025555352 0.7027793919368446 1.4707504257006898e-08 -0.0975597276101394 +1.4462000000000002 0.7027813286987005 0.7027806936854971 2.1468106153020583e-08 -0.09756045987691485 +1.4463000000000001 0.7027826315256154 0.702781994973742 2.8212112871545125e-08 -0.09756119192666737 +1.4464000000000001 0.7027839340360151 0.7027832958018884 3.493799176530754e-08 -0.09756192375945966 +1.4465 0.7027852362298018 0.7027845961702617 4.1644214757163844e-08 -0.09756265537535445 +1.4466 0.7027865381068606 0.7027858960792037 4.8329258678370124e-08 -0.09756338677441433 +1.4467 0.702787839667061 0.7027871955290719 5.4991605604251537e-08 -0.09756411795670195 +1.4468 0.702789140910256 0.7027884945202405 6.16297432306373e-08 -0.09756484892227994 +1.4469 0.7027904418362829 0.7027897930530993 6.82421651618248e-08 -0.09756557967121093 +1.447 0.7027917424449628 0.7027910911280543 7.482737130089234e-08 -0.0975663102035575 +1.4471 0.7027930427361007 0.7027923887455274 8.13838681827661e-08 -0.09756704051938221 +1.4472 0.7027943427094853 0.7027936859059558 8.791016929514395e-08 -0.09756777061874758 +1.4473000000000003 0.7027956423648902 0.7027949826097937 9.440479542197067e-08 -0.09756850050171618 +1.4474 0.702796941702073 0.7027962788575096 1.0086627497823963e-07 -0.09756923016835056 +1.4475 0.7027982407207758 0.7027975746495886 1.0729314436908055e-07 -0.0975699596187132 +1.4476000000000002 0.7027995394207246 0.7027988699865306 1.1368394826211103e-07 -0.09757068885286657 +1.4477 0.7028008378016306 0.7028001648688513 1.200372399846883e-07 -0.09757141787087314 +1.4478000000000002 0.7028021358631892 0.7028014592970817 1.263515817875871e-07 -0.09757214667279537 +1.4479000000000002 0.7028034336050808 0.7028027532717678 1.3262554523357784e-07 -0.09757287525869573 +1.448 0.7028047310269704 0.7028040467934709 1.388577114853906e-07 -0.09757360362863662 +1.4481000000000002 0.702806028128508 0.7028053398627672 1.4504667162837381e-07 -0.09757433178268039 +1.4482000000000002 0.7028073249093285 0.7028066324802478 1.511910269584582e-07 -0.09757505972088946 +1.4483000000000001 0.7028086213690523 0.7028079246465185 1.572893893846128e-07 -0.09757578744332622 +1.4484000000000001 0.7028099175072849 0.7028092163622001 1.6334038164741993e-07 -0.09757651495005298 +1.4485 0.7028112133236171 0.7028105076279272 1.6934263768683677e-07 -0.09757724224113203 +1.4486 0.7028125088176255 0.7028117984443498 1.752948029440371e-07 -0.09757796931662578 +1.4487 0.7028138039888719 0.7028130888121317 1.8119553462855875e-07 -0.09757869617659651 +1.4488 0.7028150988369044 0.7028143787319506 1.8704350208606502e-07 -0.09757942282110647 +1.4489 0.7028163933612566 0.7028156682044986 1.928373870412059e-07 -0.09758014925021792 +1.449 0.7028176875614485 0.7028169572304819 1.9857588393762393e-07 -0.09758087546399319 +1.4491 0.7028189814369857 0.7028182458106199 2.0425770017734601e-07 -0.09758160146249446 +1.4492 0.7028202749873607 0.7028195339456458 2.09881556474667e-07 -0.09758232724578392 +1.4493000000000003 0.7028215682120522 0.7028208216363063 2.1544618709901098e-07 -0.09758305281392377 +1.4494 0.7028228611105253 0.7028221088833617 2.2095034019065096e-07 -0.09758377816697617 +1.4495 0.7028241536822324 0.7028233956875851 2.2639277799663127e-07 -0.09758450330500332 +1.4496000000000002 0.7028254459266126 0.702824682049763 2.317722772177122e-07 -0.09758522822806737 +1.4497 0.7028267378430917 0.7028259679706937 2.370876292373536e-07 -0.09758595293623039 +1.4498000000000002 0.7028280294310834 0.7028272534511897 2.4233764038539274e-07 -0.09758667742955454 +1.4499000000000002 0.7028293206899885 0.7028285384920752 2.475211322156001e-07 -0.09758740170810193 +1.45 0.7028306116191952 0.702829823094187 2.5263694179017415e-07 -0.09758812577193464 +1.4501000000000002 0.7028319022180796 0.7028311072583736 2.5768392195035794e-07 -0.09758884962111464 +1.4502000000000002 0.7028331924860056 0.7028323909854963 2.626609415176673e-07 -0.0975895732557041 +1.4503000000000001 0.7028344824223254 0.7028336742764277 2.6756688559226305e-07 -0.09759029667576492 +1.4504000000000001 0.7028357720263795 0.7028349571320527 2.7240065578193473e-07 -0.09759101988135928 +1.4505 0.7028370612974963 0.7028362395532665 2.7716117047965616e-07 -0.097591742872549 +1.4506000000000001 0.7028383502349935 0.7028375215409768 2.8184736503705787e-07 -0.09759246564939615 +1.4507 0.7028396388381771 0.7028388030961019 2.864581921044329e-07 -0.09759318821196268 +1.4508 0.7028409271063423 0.7028400842195712 2.909926217556369e-07 -0.09759391056031046 +1.4509 0.7028422150387733 0.702841364912325 2.9544964182809386e-07 -0.09759463269450147 +1.451 0.7028435026347444 0.7028426451753136 2.998282580268796e-07 -0.0975953546145977 +1.4511 0.7028447898935184 0.7028439250094984 3.0412749423697205e-07 -0.0975960763206609 +1.4512 0.7028460768143482 0.7028452044158504 3.083463927591734e-07 -0.09759679781275299 +1.4513000000000003 0.7028473633964771 0.7028464833953509 3.124840144141938e-07 -0.09759751909093586 +1.4514 0.7028486496391385 0.702847761948991 3.1653943882020696e-07 -0.09759824015527134 +1.4515 0.7028499355415556 0.7028490400777709 3.205117646426503e-07 -0.09759896100582123 +1.4516000000000002 0.7028512211029426 0.7028503177827008 3.2440010973300293e-07 -0.09759968164264733 +1.4517 0.7028525063225044 0.7028515950647997 3.2820361129531905e-07 -0.09760040206581148 +1.4518000000000002 0.702853791199437 0.7028528719250955 3.3192142614296705e-07 -0.09760112227537537 +1.4519000000000002 0.7028550757329273 0.7028541483646249 3.355527308998574e-07 -0.09760184227140084 +1.452 0.702856359922154 0.7028554243844334 3.3909672206983155e-07 -0.09760256205394957 +1.4521000000000002 0.7028576437662871 0.7028566999855748 3.4255261632115674e-07 -0.09760328162308335 +1.4522 0.7028589272644887 0.7028579751691104 3.45919650673876e-07 -0.09760400097886385 +1.4523000000000001 0.7028602104159125 0.7028592499361097 3.491970825761359e-07 -0.0976047201213527 +1.4524000000000001 0.702861493219705 0.7028605242876501 3.52384190091537e-07 -0.09760543905061164 +1.4525 0.7028627756750052 0.7028617982248164 3.5548027212117805e-07 -0.0976061577667023 +1.4526000000000001 0.7028640577809444 0.7028630717487002 3.584846485632509e-07 -0.09760687626968632 +1.4527 0.7028653395366473 0.7028643448604003 3.613966602852847e-07 -0.09760759455962531 +1.4528 0.7028666209412315 0.7028656175610224 3.642156695127241e-07 -0.0976083126365809 +1.4529 0.702867901993808 0.7028668898516786 3.669410598081124e-07 -0.09760903050061465 +1.453 0.7028691826934818 0.7028681617334871 3.6957223625844193e-07 -0.09760974815178812 +1.4531 0.7028704630393512 0.7028694332075729 3.721086255792372e-07 -0.09761046559016291 +1.4532 0.7028717430305089 0.7028707042750657 3.7454967630190517e-07 -0.09761118281580049 +1.4533000000000003 0.7028730226660422 0.7028719749371021 3.7689485880842977e-07 -0.09761189982876245 +1.4534 0.7028743019450326 0.7028732451948227 3.791436655464775e-07 -0.09761261662911025 +1.4535 0.7028755808665565 0.7028745150493744 3.8129561103633636e-07 -0.09761333321690539 +1.4536000000000002 0.7028768594296854 0.7028757845019081 3.8335023200969376e-07 -0.0976140495922093 +1.4537 0.702878137633486 0.7028770535535801 3.85307087506781e-07 -0.09761476575508352 +1.4538000000000002 0.7028794154770208 0.7028783222055505 3.8716575903596784e-07 -0.09761548170558937 +1.4539000000000002 0.7028806929593476 0.7028795904589837 3.8892585060845697e-07 -0.09761619744378833 +1.454 0.7028819700795208 0.7028808583150485 3.9058698882155074e-07 -0.09761691296974184 +1.4541000000000002 0.7028832468365905 0.7028821257749169 3.9214882287946784e-07 -0.09761762828351123 +1.4542 0.7028845232296035 0.7028833928397644 3.936110247945712e-07 -0.09761834338515785 +1.4543000000000001 0.7028857992576032 0.7028846595107701 3.949732893734903e-07 -0.09761905827474311 +1.4544000000000001 0.7028870749196305 0.7028859257891152 3.9623533426569324e-07 -0.09761977295232832 +1.4545 0.7028883502147228 0.7028871916759845 3.973969000953259e-07 -0.09762048741797473 +1.4546000000000001 0.7028896251419157 0.7028884571725651 3.984577504473341e-07 -0.09762120167174378 +1.4547 0.7028908997002418 0.7028897222800458 3.994176719229747e-07 -0.09762191571369663 +1.4548 0.702892173888732 0.7028909869996178 4.002764742716547e-07 -0.09762262954389461 +1.4549 0.7028934477064157 0.702892251332474 4.0103399024521424e-07 -0.09762334316239893 +1.455 0.7028947211523204 0.7028935152798086 4.01690075854666e-07 -0.09762405656927087 +1.4551 0.702895994225472 0.7028947788428175 4.0224461016202806e-07 -0.09762476976457161 +1.4552 0.7028972669248961 0.702896042022697 4.02697495488491e-07 -0.09762548274836237 +1.4553000000000003 0.7028985392496171 0.7028973048206444 4.0304865740747875e-07 -0.09762619552070434 +1.4554 0.7028998111986586 0.7028985672378572 4.0329804457811536e-07 -0.09762690808165861 +1.4555 0.7029010827710446 0.702899829275534 4.034456290019639e-07 -0.09762762043128644 +1.4556000000000002 0.7029023539657981 0.7029010909348723 4.0349140582873755e-07 -0.09762833256964887 +1.4557 0.7029036247819433 0.7029023522170701 4.0343539344650514e-07 -0.0976290444968071 +1.4558000000000002 0.7029048952185042 0.7029036131233245 4.032776334886301e-07 -0.09762975621282216 +1.4559000000000002 0.7029061652745052 0.702904873654832 4.030181907505037e-07 -0.09763046771775513 +1.456 0.7029074349489728 0.7029061338127883 4.026571531895451e-07 -0.09763117901166712 +1.4561000000000002 0.7029087042409335 0.7029073935983874 4.0219463186969007e-07 -0.09763189009461917 +1.4562 0.7029099731494157 0.702908653012822 4.0163076109323015e-07 -0.09763260096667226 +1.4563000000000001 0.7029112416734495 0.7029099120572835 4.0096569806080673e-07 -0.09763331162788745 +1.4564000000000001 0.7029125098120672 0.7029111707329607 4.0019962316284463e-07 -0.0976340220783258 +1.4565 0.7029137775643026 0.7029124290410406 3.9933273966730187e-07 -0.0976347323180482 +1.4566000000000001 0.7029150449291923 0.7029136869827073 3.98365273830692e-07 -0.09763544234711563 +1.4567 0.7029163119057754 0.7029149445591425 3.97297474766245e-07 -0.09763615216558907 +1.4568 0.7029175784930943 0.7029162017715248 3.9612961437451855e-07 -0.09763686177352943 +1.4569 0.7029188446901942 0.70291745862103 3.9486198731564226e-07 -0.09763757117099765 +1.457 0.7029201104961234 0.7029187151088294 3.934949109815622e-07 -0.09763828035805454 +1.4571 0.7029213759099346 0.702919971236092 3.9202872524624066e-07 -0.0976389893347611 +1.4572 0.7029226409306839 0.702921227003982 3.904637925766785e-07 -0.09763969810117816 +1.4573000000000003 0.7029239055574312 0.7029224824136593 3.88800497783115e-07 -0.09764040665736651 +1.4574 0.7029251697892416 0.70292373746628 3.8703924805372214e-07 -0.09764111500338707 +1.4575 0.7029264336251837 0.7029249921629953 3.8518047279501033e-07 -0.09764182313930056 +1.4576000000000002 0.7029276970643319 0.7029262465049514 3.83224623513867e-07 -0.09764253106516785 +1.4577 0.702928960105765 0.7029275004932897 3.811721737412288e-07 -0.09764323878104973 +1.4578000000000002 0.7029302227485674 0.7029287541291456 3.790236189349372e-07 -0.0976439462870069 +1.4579000000000002 0.702931484991829 0.7029300074136497 3.767794762576937e-07 -0.09764465358310015 +1.458 0.7029327468346454 0.7029312603479262 3.744402845909378e-07 -0.09764536066939018 +1.4581000000000002 0.7029340082761177 0.7029325129330936 3.720066043128023e-07 -0.09764606754593771 +1.4582 0.7029352693153543 0.7029337651702641 3.694790171732132e-07 -0.09764677421280349 +1.4583000000000002 0.7029365299514694 0.7029350170605433 3.6685812625225633e-07 -0.09764748067004818 +1.4584000000000001 0.7029377901835834 0.70293626860503 3.6414455566180504e-07 -0.09764818691773239 +1.4585 0.7029390500108241 0.7029375198048162 3.6133895051776443e-07 -0.09764889295591679 +1.4586000000000001 0.7029403094323268 0.7029387706609871 3.584419767180269e-07 -0.09764959878466209 +1.4587 0.7029415684472333 0.7029400211746194 3.554543207967553e-07 -0.09765030440402882 +1.4588 0.7029428270546936 0.7029412713467833 3.5237668986193293e-07 -0.09765100981407757 +1.4589 0.7029440852538649 0.702942521178541 3.4920981124147987e-07 -0.09765171501486898 +1.459 0.7029453430439128 0.7029437706709458 3.459544324693753e-07 -0.09765242000646358 +1.4591 0.702946600424011 0.702945019825044 3.426113210705517e-07 -0.09765312478892196 +1.4592 0.7029478573933416 0.7029462686418726 3.391812642625225e-07 -0.09765382936230459 +1.4593000000000003 0.7029491139510949 0.7029475171224602 3.356650690247709e-07 -0.097654533726672 +1.4594 0.702950370096471 0.7029487652678263 3.320635616338441e-07 -0.09765523788208474 +1.4595 0.7029516258286778 0.7029500130789818 3.2837758764253655e-07 -0.09765594182860321 +1.4596000000000002 0.7029528811469332 0.7029512605569277 3.24608011616212e-07 -0.09765664556628795 +1.4597 0.7029541360504645 0.7029525077026559 3.2075571695239224e-07 -0.09765734909519933 +1.4598000000000002 0.7029553905385085 0.7029537545171489 3.1682160566565143e-07 -0.09765805241539789 +1.4599000000000002 0.7029566446103117 0.7029550010013785 3.1280659815863254e-07 -0.09765875552694397 +1.46 0.7029578982651307 0.7029562471563069 3.0871163309020844e-07 -0.09765945842989796 +1.4601000000000002 0.7029591515022323 0.7029574929828861 3.0453766699384266e-07 -0.09766016112432029 +1.4602 0.7029604043208937 0.7029587384820577 3.002856742290172e-07 -0.09766086361027126 +1.4603000000000002 0.7029616567204029 0.7029599836547523 2.9595664666204335e-07 -0.0976615658878113 +1.4604000000000001 0.7029629087000584 0.70296122850189 2.9155159342320047e-07 -0.09766226795700073 +1.4605 0.7029641602591694 0.7029624730243795 2.870715407124469e-07 -0.09766296981789976 +1.4606000000000001 0.7029654113970569 0.702963717223119 2.8251753157737536e-07 -0.09766367147056881 +1.4607 0.7029666621130528 0.7029649610989945 2.7789062563565725e-07 -0.0976643729150681 +1.4608 0.7029679124065006 0.7029662046528812 2.7319189878360906e-07 -0.09766507415145796 +1.4609 0.702969162276755 0.7029674478856418 2.684224430296589e-07 -0.09766577517979855 +1.461 0.7029704117231833 0.702968690798128 2.635833662237297e-07 -0.09766647600015016 +1.4611 0.7029716607451643 0.702969933391179 2.5867579177274447e-07 -0.09766717661257303 +1.4612 0.7029729093420891 0.7029711756656214 2.5370085838388734e-07 -0.09766787701712729 +1.4613000000000003 0.7029741575133608 0.7029724176222703 2.486597198009255e-07 -0.09766857721387319 +1.4614 0.7029754052583953 0.7029736592619276 2.4355354454747014e-07 -0.09766927720287086 +1.4615 0.7029766525766212 0.7029749005853827 2.383835156771763e-07 -0.09766997698418045 +1.4616000000000002 0.7029778994674798 0.7029761415934122 2.3315083048924823e-07 -0.0976706765578621 +1.4617 0.7029791459304248 0.7029773822867798 2.2785670017455573e-07 -0.09767137592397596 +1.4618000000000002 0.7029803919649236 0.7029786226662357 2.2250234964910076e-07 -0.09767207508258202 +1.4619000000000002 0.702981637570457 0.7029798627325174 2.1708901721401164e-07 -0.09767277403374053 +1.462 0.7029828827465181 0.7029811024863486 2.1161795424329277e-07 -0.09767347277751141 +1.4621000000000002 0.7029841274926146 0.7029823419284397 2.0609042497912733e-07 -0.0976741713139548 +1.4622 0.7029853718082675 0.7029835810594871 2.005077061606464e-07 -0.09767486964313074 +1.4623000000000002 0.7029866156930109 0.7029848198801736 1.9487108674984266e-07 -0.09767556776509921 +1.4624000000000001 0.7029878591463936 0.7029860583911678 1.8918186766095357e-07 -0.09767626567992017 +1.4625 0.7029891021679782 0.7029872965931248 1.8344136141351663e-07 -0.09767696338765373 +1.4626000000000001 0.7029903447573411 0.7029885344866851 1.7765089187909977e-07 -0.09767766088835977 +1.4627000000000001 0.7029915869140733 0.7029897720724745 1.7181179396558166e-07 -0.0976783581820982 +1.4628 0.7029928286377799 0.7029910093511054 1.6592541329102373e-07 -0.09767905526892906 +1.4629 0.7029940699280808 0.7029922463231747 1.59993105864481e-07 -0.09767975214891217 +1.463 0.7029953107846101 0.7029934829892653 1.5401623778762974e-07 -0.09768044882210752 +1.4631 0.7029965512070167 0.7029947193499453 1.4799618497721156e-07 -0.09768114528857497 +1.4632 0.7029977911949646 0.7029959554057676 1.419343327764555e-07 -0.0976818415483744 +1.4633000000000003 0.702999030748132 0.7029971911572703 1.3583207570180833e-07 -0.09768253760156563 +1.4634 0.7030002698662129 0.7029984266049769 1.2969081706129537e-07 -0.09768323344820853 +1.4635 0.7030015085489154 0.702999661749395 1.2351196871165926e-07 -0.09768392908836289 +1.4636000000000002 0.7030027467959636 0.7030008965910175 1.1729695065243462e-07 -0.09768462452208855 +1.4637 0.7030039846070965 0.7030021311303221 1.1104719076920899e-07 -0.09768531974944523 +1.4638000000000002 0.7030052219820682 0.7030033653677707 1.04764124431167e-07 -0.09768601477049278 +1.4639000000000002 0.7030064589206484 0.7030045993038104 9.844919422741238e-08 -0.09768670958529092 +1.464 0.7030076954226223 0.7030058329388722 9.210384959573714e-08 -0.0976874041938994 +1.4641000000000002 0.7030089314877908 0.7030070662733714 8.572954653118803e-08 -0.09768809859637792 +1.4642 0.7030101671159695 0.7030082993077085 7.932774720616209e-08 -0.0976887927927862 +1.4643000000000002 0.703011402306991 0.7030095320422673 7.2899919654687e-08 -0.09768948678318391 +1.4644000000000001 0.7030126370607027 0.7030107644774165 6.644753743068055e-08 -0.09769018056763079 +1.4645 0.7030138713769681 0.7030119966135087 5.997207929743509e-08 -0.09769087414618643 +1.4646000000000001 0.7030151052556664 0.7030132284508802 5.3475028851182604e-08 -0.0976915675189105 +1.4647000000000001 0.7030163386966926 0.7030144599898522 4.6957874205375005e-08 -0.0976922606858626 +1.4648 0.7030175716999578 0.7030156912307295 4.042210763159637e-08 -0.09769295364710234 +1.4649 0.703018804265389 0.7030169221738007 3.386922524384328e-08 -0.09769364640268935 +1.465 0.7030200363929291 0.7030181528193389 2.7300726623824545e-08 -0.09769433895268316 +1.4651 0.703021268082537 0.7030193831676004 2.0718114508710972e-08 -0.09769503129714333 +1.4652 0.7030224993341879 0.7030206132188261 1.4122894425108723e-08 -0.09769572343612945 +1.4653000000000003 0.7030237301478728 0.7030218429732402 7.516574357727124e-09 -0.09769641536970099 +1.4654 0.703024960523599 0.7030230724310511 9.006643954950766e-10 -0.0976971070979175 +1.4655 0.7030261904613898 0.7030243015924508 -5.723323603240571e-09 -0.09769779862083841 +1.4656000000000002 0.7030274199612848 0.7030255304576152 -1.2353876361129168e-08 -0.0976984899385233 +1.4657 0.7030286490233395 0.7030267590267039 -1.898947953136304e-08 -0.09769918105103156 +1.4658000000000002 0.7030298776476256 0.7030279872998605 -2.5628618040285378e-08 -0.09769987195842264 +1.4659 0.7030311058342311 0.7030292152772121 -3.226977642913076e-08 -0.09770056266075597 +1.466 0.7030323335832602 0.7030304429588697 -3.8911439206716116e-08 -0.09770125315809099 +1.4661000000000002 0.7030335608948333 0.7030316703449282 -4.555209118939233e-08 -0.09770194345048704 +1.4662 0.7030347877690863 0.7030328974354662 -5.219021785162099e-08 -0.09770263353800354 +1.4663000000000002 0.703036014206172 0.7030341242305461 -5.882430566695601e-08 -0.09770332342069984 +1.4664000000000001 0.7030372402062591 0.7030353507302141 -6.545284245412092e-08 -0.0977040130986353 +1.4665 0.7030384657695321 0.7030365769345003 -7.207431772628461e-08 -0.0977047025718692 +1.4666000000000001 0.703039690896192 0.7030378028434183 -7.868722302906139e-08 -0.09770539184046086 +1.4667000000000001 0.7030409155864557 0.7030390284569665 -8.529005228376935e-08 -0.09770608090446964 +1.4668 0.703042139840556 0.7030402537751261 -9.188130213871187e-08 -0.09770676976395473 +1.4669 0.7030433636587418 0.703041478797863 -9.845947230007618e-08 -0.09770745841897549 +1.467 0.7030445870412781 0.703042703525127 -1.0502306588017901e-07 -0.09770814686959114 +1.4671 0.7030458099884456 0.7030439279568519 -1.1157058973747247e-07 -0.0977088351158609 +1.4672 0.7030470325005407 0.7030451520929547 -1.1810055481481507e-07 -0.09770952315784392 +1.4673000000000003 0.7030482545778762 0.7030463759333379 -1.2461147647600812e-07 -0.09771021099559951 +1.4674 0.7030494762207804 0.7030475994778873 -1.311018748544751e-07 -0.09771089862918683 +1.4675 0.7030506974295969 0.7030488227264733 -1.3757027517505294e-07 -0.097711586058665 +1.4676000000000002 0.7030519182046857 0.7030500456789504 -1.4401520809746715e-07 -0.09771227328409321 +1.4677 0.7030531385464216 0.7030512683351572 -1.504352100372558e-07 -0.09771296030553056 +1.4678000000000002 0.7030543584551955 0.7030524906949172 -1.5682882352138772e-07 -0.09771364712303615 +1.4679 0.7030555779314136 0.7030537127580382 -1.631945975005128e-07 -0.0977143337366691 +1.468 0.7030567969754975 0.7030549345243124 -1.6953108768376357e-07 -0.09771502014648856 +1.4681000000000002 0.7030580155878842 0.7030561559935171 -1.7583685686314854e-07 -0.09771570635255356 +1.4682 0.7030592337690253 0.7030573771654135 -1.8211047524488433e-07 -0.09771639235492308 +1.4683000000000002 0.7030604515193888 0.7030585980397481 -1.8835052077725845e-07 -0.09771707815365621 +1.4684000000000001 0.7030616688394568 0.7030598186162524 -1.945555794628795e-07 -0.09771776374881198 +1.4685 0.7030628857297263 0.7030610388946427 -2.007242456865399e-07 -0.09771844914044941 +1.4686000000000001 0.7030641021907098 0.7030622588746203 -2.0685512249624116e-07 -0.09771913432862744 +1.4687000000000001 0.7030653182229342 0.7030634785558714 -2.1294682201605797e-07 -0.09771981931340508 +1.4688 0.7030665338269411 0.7030646979380679 -2.1899796565777452e-07 -0.09772050409484123 +1.4689 0.7030677490032871 0.7030659170208673 -2.2500718448170698e-07 -0.09772118867299495 +1.469 0.7030689637525427 0.7030671358039114 -2.3097311948119814e-07 -0.09772187304792503 +1.4691 0.703070178075293 0.703068354286829 -2.3689442192609267e-07 -0.09772255721969046 +1.4692 0.7030713919721372 0.7030695724692337 -2.427697536507012e-07 -0.09772324118835007 +1.4693000000000003 0.7030726054436891 0.7030707903507254 -2.4859778731400883e-07 -0.09772392495396282 +1.4694 0.7030738184905758 0.703072007930889 -2.543772068056005e-07 -0.09772460851658743 +1.4695 0.7030750311134388 0.7030732252092965 -2.601067074087249e-07 -0.09772529187628283 +1.4696000000000002 0.7030762433129336 0.7030744421855057 -2.6578499621315865e-07 -0.09772597503310787 +1.4697 0.7030774550897285 0.7030756588590605 -2.7141079231990384e-07 -0.09772665798712127 +1.4698000000000002 0.7030786664445063 0.7030768752294918 -2.769828271811936e-07 -0.09772734073838193 +1.4699 0.7030798773779622 0.7030780912963164 -2.824998448849869e-07 -0.09772802328694855 +1.47 0.7030810878908051 0.7030793070590381 -2.879606023874215e-07 -0.09772870563287987 +1.4701000000000002 0.7030822979837574 0.7030805225171477 -2.9336386984935015e-07 -0.09772938777623473 +1.4702 0.7030835076575537 0.7030817376701226 -2.9870843090695764e-07 -0.0977300697170718 +1.4703000000000002 0.703084716912942 0.7030829525174278 -3.039930829076831e-07 -0.0977307514554498 +1.4704000000000002 0.7030859257506826 0.7030841670585151 -3.0921663722593973e-07 -0.09773143299142739 +1.4705 0.7030871341715487 0.703085381292824 -3.143779195025065e-07 -0.09773211432506336 +1.4706000000000001 0.7030883421763248 0.7030865952197819 -3.1947576990126736e-07 -0.09773279545641622 +1.4707000000000001 0.7030895497658088 0.7030878088388035 -3.245090434145226e-07 -0.09773347638554475 +1.4708 0.70309075694081 0.7030890221492915 -3.294766100503388e-07 -0.09773415711250749 +1.4709 0.7030919637021498 0.7030902351506367 -3.3437735517949374e-07 -0.09773483763736308 +1.471 0.7030931700506611 0.7030914478422186 -3.3921017965343747e-07 -0.09773551796017016 +1.4711 0.7030943759871886 0.7030926602234042 -3.439740002067482e-07 -0.09773619808098727 +1.4712 0.7030955815125878 0.7030938722935502 -3.486677495889712e-07 -0.09773687799987302 +1.4713000000000003 0.703096786627726 0.7030950840520009 -3.53290376821358e-07 -0.09773755771688589 +1.4714 0.703097991333481 0.7030962954980903 -3.578408474952388e-07 -0.09773823723208443 +1.4715 0.7030991956307422 0.7030975066311413 -3.623181438899836e-07 -0.09773891654552722 +1.4716000000000002 0.7031003995204086 0.7030987174504663 -3.667212653130081e-07 -0.0977395956572727 +1.4717 0.7031016030033904 0.7030999279553667 -3.7104922826630693e-07 -0.09774027456737938 +1.4718000000000002 0.7031028060806077 0.7031011381451342 -3.753010666684986e-07 -0.09774095327590575 +1.4719 0.703104008752991 0.7031023480190499 -3.794758321254421e-07 -0.0977416317829102 +1.472 0.7031052110214802 0.7031035575763851 -3.8357259399268706e-07 -0.09774231008845125 +1.4721000000000002 0.7031064128870256 0.7031047668164012 -3.87590439812624e-07 -0.09774298819258728 +1.4722 0.703107614350586 0.7031059757383502 -3.9152847527978984e-07 -0.09774366609537662 +1.4723000000000002 0.7031088154131309 0.703107184341475 -3.953858246016906e-07 -0.09774434379687781 +1.4724000000000002 0.7031100160756374 0.7031083926250088 -3.991616306445178e-07 -0.09774502129714911 +1.4725 0.7031112163390925 0.7031096005881761 -4.0285505509968234e-07 -0.09774569859624893 +1.4726000000000001 0.7031124162044916 0.7031108082301927 -4.064652787058587e-07 -0.0977463756942356 +1.4727000000000001 0.7031136156728386 0.7031120155502659 -4.0999150142939644e-07 -0.09774705259116744 +1.4728 0.7031148147451455 0.7031132225475942 -4.1343294257534247e-07 -0.09774772928710271 +1.4729 0.7031160134224329 0.7031144292213687 -4.1678884109275227e-07 -0.09774840578209983 +1.473 0.7031172117057287 0.7031156355707717 -4.200584556093845e-07 -0.09774908207621694 +1.4731 0.703118409596069 0.7031168415949787 -4.2324106465374545e-07 -0.09774975816951241 +1.4732 0.7031196070944965 0.703118047293157 -4.263359668077449e-07 -0.09775043406204442 +1.4733000000000003 0.7031208042020618 0.7031192526644667 -4.2934248088016824e-07 -0.09775110975387118 +1.4734 0.7031220009198228 0.7031204577080613 -4.322599460246379e-07 -0.09775178524505096 +1.4735 0.7031231972488432 0.7031216624230869 -4.350877219269633e-07 -0.09775246053564188 +1.4736000000000002 0.703124393190194 0.7031228668086836 -4.3782518886759103e-07 -0.0977531356257022 +1.4737 0.7031255887449523 0.7031240708639845 -4.404717479297715e-07 -0.09775381051529006 +1.4738000000000002 0.7031267839142017 0.7031252745881167 -4.43026821138337e-07 -0.09775448520446361 +1.4739 0.7031279786990309 0.7031264779802016 -4.454898515152128e-07 -0.09775515969328097 +1.474 0.7031291731005349 0.7031276810393543 -4.478603032528894e-07 -0.09775583398180024 +1.4741000000000002 0.7031303671198139 0.7031288837646853 -4.501376618462616e-07 -0.09775650807007955 +1.4742 0.7031315607579736 0.7031300861552988 -4.5232143414120074e-07 -0.09775718195817697 +1.4743000000000002 0.7031327540161243 0.7031312882102949 -4.544111485219049e-07 -0.0977578556461506 +1.4744000000000002 0.7031339468953812 0.7031324899287679 -4.5640635489702097e-07 -0.09775852913405843 +1.4745 0.7031351393968643 0.7031336913098085 -4.583066249078116e-07 -0.09775920242195858 +1.4746000000000001 0.7031363315216972 0.7031348923525023 -4.6011155199060516e-07 -0.09775987550990896 +1.4747000000000001 0.7031375232710082 0.7031360930559313 -4.6182075143924584e-07 -0.09776054839796765 +1.4748 0.7031387146459294 0.7031372934191735 -4.634338605022381e-07 -0.09776122108619265 +1.4749 0.703139905647596 0.7031384934413029 -4.6495053843131906e-07 -0.09776189357464185 +1.475 0.7031410962771469 0.7031396931213905 -4.6637046664799175e-07 -0.0977625658633733 +1.4751 0.7031422865357242 0.7031408924585042 -4.676933486463808e-07 -0.09776323795244492 +1.4752 0.7031434764244724 0.7031420914517086 -4.6891891022221577e-07 -0.09776390984191459 +1.4753000000000003 0.7031446659445393 0.7031432901000658 -4.7004689941732014e-07 -0.09776458153184026 +1.4754 0.7031458550970745 0.7031444884026353 -4.710770866514502e-07 -0.09776525302227979 +1.4755 0.7031470438832301 0.7031456863584746 -4.7200926466678395e-07 -0.09776592431329106 +1.4756000000000002 0.70314823230416 0.7031468839666393 -4.728432486666989e-07 -0.09776659540493197 +1.4757 0.7031494203610199 0.7031480812261827 -4.735788763157722e-07 -0.09776726629726032 +1.4758000000000002 0.7031506080549668 0.7031492781361569 -4.7421600776753614e-07 -0.09776793699033391 +1.4759 0.7031517953871587 0.7031504746956133 -4.747545256436614e-07 -0.09776860748421062 +1.476 0.7031529823587552 0.7031516709036016 -4.751943351866128e-07 -0.0977692777789482 +1.4761000000000002 0.7031541689709159 0.7031528667591711 -4.755353641139326e-07 -0.0977699478746045 +1.4762 0.7031553552248011 0.7031540622613702 -4.757775627500793e-07 -0.09777061777123719 +1.4763000000000002 0.7031565411215719 0.7031552574092473 -4.759209039709167e-07 -0.0977712874689041 +1.4764000000000002 0.7031577266623883 0.7031564522018507 -4.759653832175914e-07 -0.09777195696766289 +1.4765 0.703158911848411 0.7031576466382289 -4.7591101851041095e-07 -0.09777262626757131 +1.4766000000000001 0.7031600966807998 0.7031588407174306 -4.757578503794546e-07 -0.09777329536868706 +1.4767000000000001 0.703161281160714 0.7031600344385056 -4.7550594193396245e-07 -0.09777396427106787 +1.4768000000000001 0.7031624652893114 0.7031612278005042 -4.751553788068241e-07 -0.09777463297477133 +1.4769 0.7031636490677493 0.703162420802478 -4.747062690782511e-07 -0.09777530147985512 +1.477 0.7031648324971831 0.7031636134434803 -4.7415874328271546e-07 -0.09777596978637691 +1.4771 0.7031660155787667 0.7031648057225655 -4.735129544228278e-07 -0.09777663789439434 +1.4772 0.7031671983136516 0.7031659976387901 -4.727690778444371e-07 -0.09777730580396492 +1.4773000000000003 0.7031683807029878 0.7031671891912128 -4.7192731125744736e-07 -0.09777797351514629 +1.4774 0.7031695627479226 0.7031683803788946 -4.709878746247953e-07 -0.09777864102799604 +1.4775 0.7031707444496007 0.7031695712008987 -4.6995101014857266e-07 -0.09777930834257167 +1.4776000000000002 0.703171925809164 0.7031707616562923 -4.6881698221451495e-07 -0.09777997545893083 +1.4777 0.7031731068277508 0.7031719517441442 -4.67586077294857e-07 -0.09778064237713095 +1.4778000000000002 0.7031742875064967 0.7031731414635272 -4.66258603878944e-07 -0.09778130909722957 +1.4779 0.7031754678465334 0.7031743308135175 -4.6483489242465925e-07 -0.0977819756192842 +1.478 0.7031766478489887 0.7031755197931956 -4.633152952057684e-07 -0.0977826419433523 +1.4781000000000002 0.7031778275149866 0.703176708401645 -4.617001863743697e-07 -0.09778330806949136 +1.4782 0.7031790068456465 0.703177896637954 -4.5998996171109363e-07 -0.09778397399775877 +1.4783000000000002 0.7031801858420835 0.7031790845012156 -4.581850386042863e-07 -0.09778463972821197 +1.4784000000000002 0.7031813645054079 0.7031802719905269 -4.5628585595286486e-07 -0.09778530526090841 +1.4785 0.7031825428367253 0.7031814591049903 -4.542928740275398e-07 -0.09778597059590549 +1.4786000000000001 0.7031837208371354 0.7031826458437131 -4.522065743389758e-07 -0.09778663573326055 +1.4787000000000001 0.7031848985077332 0.7031838322058085 -4.500274596169751e-07 -0.09778730067303103 +1.4788000000000001 0.7031860758496078 0.7031850181903946 -4.4775605360231063e-07 -0.09778796541527421 +1.4789 0.7031872528638421 0.7031862037965957 -4.4539290099815387e-07 -0.09778862996004745 +1.479 0.7031884295515134 0.7031873890235418 -4.429385672272135e-07 -0.09778929430740807 +1.4791 0.7031896059136926 0.7031885738703699 -4.403936383970408e-07 -0.09778995845741341 +1.4792 0.7031907819514437 0.7031897583362223 -4.37758721105741e-07 -0.09779062241012065 +1.4793000000000003 0.7031919576658242 0.7031909424202492 -4.3503444233788935e-07 -0.09779128616558716 +1.4794 0.7031931330578848 0.7031921261216069 -4.322214492841203e-07 -0.09779194972387018 +1.4795 0.7031943081286687 0.7031933094394593 -4.293204092092884e-07 -0.0977926130850269 +1.4796 0.7031954828792117 0.7031944923729774 -4.263320093067513e-07 -0.0977932762491146 +1.4797 0.7031966573105428 0.7031956749213397 -4.2325695645550887e-07 -0.0977939392161905 +1.4798000000000002 0.7031978314236819 0.7031968570837328 -4.2009597713693614e-07 -0.09779460198631178 +1.4799 0.7031990052196415 0.7031980388593506 -4.168498172404944e-07 -0.09779526455953556 +1.48 0.7032001786994262 0.7031992202473958 -4.1351924193883116e-07 -0.09779592693591904 +1.4801000000000002 0.7032013518640318 0.7032004012470794 -4.101050353547131e-07 -0.09779658911551943 +1.4802 0.7032025247144454 0.7032015818576207 -4.066080005610262e-07 -0.09779725109839381 +1.4803000000000002 0.7032036972516453 0.7032027620782478 -4.0302895928240323e-07 -0.09779791288459923 +1.4804000000000002 0.703204869476601 0.7032039419081979 -3.993687517009348e-07 -0.09779857447419288 +1.4805 0.7032060413902725 0.7032051213467174 -3.956282363312691e-07 -0.09779923586723177 +1.4806000000000001 0.7032072129936107 0.703206300393062 -3.918082897291786e-07 -0.09779989706377301 +1.4807000000000001 0.7032083842875565 0.7032074790464967 -3.879098063805375e-07 -0.09780055806387364 +1.4808000000000001 0.7032095552730413 0.7032086573062968 -3.8393369841682734e-07 -0.09780121886759072 +1.4809 0.7032107259509865 0.7032098351717471 -3.798808954139088e-07 -0.09780187947498122 +1.481 0.7032118963223031 0.7032110126421426 -3.7575234421854953e-07 -0.09780253988610219 +1.4811 0.703213066387892 0.7032121897167884 -3.7154900870556284e-07 -0.09780320010101057 +1.4812 0.7032142361486435 0.7032133663950006 -3.672718695141297e-07 -0.09780386011976339 +1.4813000000000003 0.7032154056054373 0.7032145426761054 -3.629219238743264e-07 -0.09780451994241755 +1.4814 0.7032165747591419 0.70321571855944 -3.585001853642633e-07 -0.09780517956903001 +1.4815 0.703217743610615 0.7032168940443526 -3.540076836186512e-07 -0.09780583899965768 +1.4816 0.7032189121607031 0.7032180691302029 -3.4944546419696243e-07 -0.09780649823435754 +1.4817 0.7032200804102413 0.7032192438163613 -3.448145881948528e-07 -0.09780715727318641 +1.4818000000000002 0.7032212483600528 0.7032204181022101 -3.4011613214701697e-07 -0.09780781611620121 +1.4819 0.7032224160109497 0.703221591987143 -3.353511876663662e-07 -0.09780847476345873 +1.482 0.7032235833637319 0.7032227654705658 -3.305208612774946e-07 -0.09780913321501591 +1.4821000000000002 0.7032247504191874 0.7032239385518964 -3.2562627407667355e-07 -0.09780979147092955 +1.4822 0.7032259171780917 0.7032251112305641 -3.206685615445015e-07 -0.09781044953125645 +1.4823000000000002 0.7032270836412082 0.7032262835060112 -3.1564887323365376e-07 -0.09781110739605342 +1.4824000000000002 0.7032282498092877 0.7032274553776919 -3.105683725052044e-07 -0.0978117650653772 +1.4825 0.703229415683069 0.7032286268450736 -3.054282362788263e-07 -0.09781242253928465 +1.4826000000000001 0.7032305812632771 0.7032297979076356 -3.0022965481074637e-07 -0.09781307981783244 +1.4827000000000001 0.7032317465506248 0.7032309685648706 -2.9497383124965637e-07 -0.09781373690107736 +1.4828000000000001 0.7032329115458116 0.703232138816284 -2.8966198156732403e-07 -0.09781439378907603 +1.4829 0.703234076249524 0.7032333086613944 -2.8429533414572883e-07 -0.09781505048188524 +1.483 0.7032352406624354 0.7032344780997342 -2.7887512951685345e-07 -0.09781570697956168 +1.4831 0.7032364047852051 0.7032356471308481 -2.7340262013023087e-07 -0.09781636328216202 +1.4832 0.7032375686184796 0.703236815754295 -2.6787906994008015e-07 -0.09781701938974294 +1.4833000000000003 0.7032387321628915 0.7032379839696474 -2.623057542908147e-07 -0.09781767530236107 +1.4834 0.703239895419059 0.703239151776491 -2.56683959479892e-07 -0.09781833102007301 +1.4835 0.7032410583875868 0.7032403191744261 -2.51014982490666e-07 -0.09781898654293533 +1.4836 0.7032422210690662 0.7032414861630665 -2.453001307460567e-07 -0.09781964187100471 +1.4837 0.7032433834640739 0.70324265274204 -2.3954072174078855e-07 -0.09782029700433773 +1.4838000000000002 0.703244545573172 0.7032438189109887 -2.337380827881208e-07 -0.09782095194299088 +1.4839 0.7032457073969085 0.7032449846695689 -2.2789355070412798e-07 -0.09782160668702072 +1.484 0.7032468689358174 0.7032461500174512 -2.2200847146075509e-07 -0.09782226123648378 +1.4841000000000002 0.7032480301904178 0.7032473149543211 -2.1608419993254802e-07 -0.09782291559143663 +1.4842 0.7032491911612146 0.7032484794798783 -2.101220995462394e-07 -0.09782356975193579 +1.4843000000000002 0.7032503518486974 0.7032496435938371 -2.0412354197543725e-07 -0.09782422371803771 +1.4844000000000002 0.703251512253341 0.7032508072959266 -1.9808990684572203e-07 -0.09782487748979883 +1.4845 0.7032526723756061 0.7032519705858905 -1.92022581380763e-07 -0.09782553106727561 +1.4846000000000001 0.703253832215938 0.7032531334634877 -1.8592296010741527e-07 -0.09782618445052453 +1.4847000000000001 0.7032549917747669 0.7032542959284921 -1.797924445400001e-07 -0.09782683763960202 +1.4848000000000001 0.7032561510525079 0.7032554579806922 -1.736324428611158e-07 -0.09782749063456443 +1.4849 0.7032573100495609 0.7032566196198917 -1.6744436955561104e-07 -0.09782814343546814 +1.485 0.7032584687663113 0.7032577808459102 -1.612296451417028e-07 -0.09782879604236962 +1.4851 0.7032596272031281 0.7032589416585815 -1.5498969581015376e-07 -0.09782944845532515 +1.4852 0.7032607853603656 0.7032601020577549 -1.487259531206958e-07 -0.09783010067439109 +1.4853000000000003 0.7032619432383633 0.7032612620432955 -1.424398536342686e-07 -0.09783075269962381 +1.4854 0.7032631008374439 0.7032624216150836 -1.3613283864240266e-07 -0.0978314045310796 +1.4855 0.7032642581579158 0.7032635807730145 -1.298063537803762e-07 -0.09783205616881474 +1.4856 0.703265415200071 0.7032647395169995 -1.234618487305772e-07 -0.09783270761288551 +1.4857 0.7032665719641868 0.703265897846965 -1.171007768859672e-07 -0.09783335886334824 +1.4858000000000002 0.7032677284505242 0.7032670557628535 -1.1072459499446297e-07 -0.09783400992025912 +1.4859 0.7032688846593289 0.7032682132646221 -1.0433476285882926e-07 -0.09783466078367438 +1.486 0.7032700405908308 0.7032693703522445 -9.793274297672377e-08 -0.09783531145365026 +1.4861000000000002 0.7032711962452443 0.7032705270257097 -9.152000021803858e-08 -0.09783596193024302 +1.4862 0.7032723516227677 0.7032716832850221 -8.509800149356789e-08 -0.09783661221350876 +1.4863000000000002 0.7032735067235841 0.7032728391302019 -7.866821540893076e-08 -0.0978372623035037 +1.4864000000000002 0.7032746615478607 0.7032739945612851 -7.223211192890211e-08 -0.097837912200284 +1.4865 0.7032758160957485 0.7032751495783234 -6.579116205085098e-08 -0.09783856190390576 +1.4866000000000001 0.7032769703673836 0.7032763041813839 -5.934683746343372e-08 -0.09783921141442516 +1.4867000000000001 0.7032781243628854 0.7032774583705501 -5.290061020875661e-08 -0.09783986073189832 +1.4868000000000001 0.7032792780823582 0.70327861214592 -4.645395235180257e-08 -0.09784050985638126 +1.4869 0.7032804315258905 0.7032797655076084 -4.000833563782332e-08 -0.09784115878793015 +1.487 0.7032815846935547 0.7032809184557454 -3.356523116046506e-08 -0.09784180752660099 +1.4871 0.7032827375854076 0.7032820709904766 -2.712610902436477e-08 -0.09784245607244985 +1.4872 0.7032838902014906 0.7032832231119637 -2.0692438011324366e-08 -0.09784310442553279 +1.4873000000000003 0.7032850425418289 0.7032843748203832 -1.4265685243340653e-08 -0.09784375258590577 +1.4874 0.7032861946064324 0.7032855261159285 -7.847315850514208e-09 -0.09784440055362485 +1.4875 0.7032873463952951 0.7032866769988075 -1.4387926362477432e-09 -0.09784504832874599 +1.4876 0.7032884979083955 0.7032878274692443 4.958424257121841e-09 -0.09784569591132516 +1.4877 0.7032896491456966 0.7032889775274782 1.1342877677920915e-08 -0.09784634330141836 +1.4878000000000002 0.7032908001071455 0.7032901271737642 1.7713113801241798e-08 -0.09784699049908147 +1.4879 0.7032919507926743 0.7032912764083725 2.4067682458973894e-08 -0.09784763750437045 +1.488 0.7032931012021987 0.7032924252315889 3.040513747026852e-08 -0.09784828431734116 +1.4881000000000002 0.7032942513356203 0.7032935736437149 3.6724036957258566e-08 -0.09784893093804958 +1.4882 0.7032954011928241 0.7032947216450665 4.3022943698942107e-08 -0.0978495773665515 +1.4883000000000002 0.7032965507736807 0.7032958692359759 4.930042544169788e-08 -0.09785022360290285 +1.4884000000000002 0.7032977000780447 0.7032970164167898 5.555505521934179e-08 -0.09785086964715944 +1.4885 0.703298849105756 0.7032981631878705 6.178541168966323e-08 -0.09785151549937718 +1.4886000000000001 0.703299997856639 0.7032993095495953 6.799007945187951e-08 -0.09785216115961179 +1.4887000000000001 0.7033011463305032 0.7033004555023561 7.416764936755971e-08 -0.09785280662791912 +1.4888000000000001 0.7033022945271434 0.7033016010465605 8.031671888328318e-08 -0.09785345190435496 +1.4889000000000001 0.7033034424463387 0.70330274618263 8.643589235329818e-08 -0.09785409698897503 +1.489 0.7033045900878541 0.7033038909110019 9.252378134483319e-08 -0.09785474188183513 +1.4891 0.7033057374514393 0.7033050352321277 9.857900495902072e-08 -0.097855386582991 +1.4892 0.7033068845368295 0.7033061791464736 1.0460019014141286e-07 -0.09785603109249838 +1.4893000000000003 0.7033080313437454 0.7033073226545205 1.1058597199423148e-07 -0.09785667541041294 +1.4894 0.7033091778718932 0.7033084657567633 1.1653499410596568e-07 -0.09785731953679039 +1.4895 0.7033103241209642 0.7033096084537118 1.2244590882545814e-07 -0.09785796347168636 +1.4896 0.7033114700906362 0.7033107507458898 1.2831737757762474e-07 -0.09785860721515661 +1.4897 0.7033126157805725 0.7033118926338351 1.3414807117223537e-07 -0.09785925076725675 +1.4898000000000002 0.7033137611904214 0.7033130341181 1.3993667009881694e-07 -0.09785989412804236 +1.4899 0.7033149063198184 0.7033141751992504 1.4568186485278134e-07 -0.0978605372975691 +1.49 0.7033160511683845 0.7033153158778664 1.5138235618175622e-07 -0.09786118027589258 +1.4901000000000002 0.7033171957357272 0.7033164561545415 1.5703685541865187e-07 -0.0978618230630684 +1.4902 0.7033183400214399 0.7033175960298826 1.6264408475574754e-07 -0.09786246565915208 +1.4903000000000002 0.7033194840251027 0.7033187355045107 1.6820277754653334e-07 -0.09786310806419918 +1.4904000000000002 0.7033206277462826 0.7033198745790596 1.7371167857632708e-07 -0.09786375027826527 +1.4905 0.7033217711845325 0.7033210132541767 1.791695443537078e-07 -0.09786439230140581 +1.4906000000000001 0.7033229143393933 0.7033221515305228 1.8457514338113268e-07 -0.09786503413367643 +1.4907000000000001 0.7033240572103916 0.7033232894087709 1.8992725645330943e-07 -0.09786567577513254 +1.4908000000000001 0.7033251997970418 0.7033244268896073 1.9522467691740486e-07 -0.0978663172258296 +1.4909000000000001 0.7033263420988454 0.7033255639737309 2.0046621094713113e-07 -0.09786695848582311 +1.491 0.703327484115291 0.7033267006618533 2.0565067779948487e-07 -0.09786759955516847 +1.4911 0.7033286258458558 0.7033278369546987 2.1077691011658906e-07 -0.09786824043392123 +1.4912 0.7033297672900027 0.7033289728530033 2.1584375414426815e-07 -0.09786888112213671 +1.4913000000000003 0.7033309084471844 0.7033301083575152 2.2085007003735946e-07 -0.09786952161987028 +1.4914 0.7033320493168407 0.7033312434689951 2.2579473208522716e-07 -0.09787016192717744 +1.4915 0.7033331898983988 0.703332378188215 2.3067662895809304e-07 -0.09787080204411347 +1.4916 0.7033343301912754 0.703333512515959 2.354946639707145e-07 -0.09787144197073377 +1.4917 0.7033354701948751 0.7033346464530223 2.4024775532871523e-07 -0.09787208170709363 +1.4918000000000002 0.7033366099085911 0.7033357800002116 2.449348363783854e-07 -0.09787272125324843 +1.4919 0.7033377493318052 0.7033369131583449 2.4955485584260417e-07 -0.09787336060925343 +1.492 0.7033388884638883 0.7033380459282513 2.5410677804288406e-07 -0.09787399977516396 +1.4921000000000002 0.7033400273042005 0.7033391783107704 2.5858958315611025e-07 -0.0978746387510353 +1.4922 0.7033411658520907 0.7033403103067527 2.630022673880128e-07 -0.09787527753692264 +1.4923000000000002 0.7033423041068984 0.7033414419170594 2.6734384325766136e-07 -0.09787591613288138 +1.4924000000000002 0.7033434420679512 0.7033425731425615 2.716133398472653e-07 -0.09787655453896661 +1.4925 0.7033445797345674 0.7033437039841406 2.7580980290625723e-07 -0.0978771927552336 +1.4926000000000001 0.7033457171060551 0.703344834442688 2.7993229513578743e-07 -0.09787783078173756 +1.4927000000000001 0.7033468541817124 0.7033459645191055 2.8397989645240207e-07 -0.09787846861853368 +1.4928000000000001 0.7033479909608278 0.7033470942143032 2.879517040366153e-07 -0.0978791062656771 +1.4929000000000001 0.7033491274426806 0.7033482235292015 2.91846832679854e-07 -0.09787974372322296 +1.493 0.7033502636265407 0.7033493524647298 2.9566441495099127e-07 -0.09788038099122648 +1.4931 0.7033513995116688 0.703350481021827 2.994036013420631e-07 -0.09788101806974275 +1.4932 0.7033525350973167 0.7033516092014398 3.0306356048337424e-07 -0.09788165495882685 +1.4933 0.7033536703827272 0.7033527370045243 3.066434793447259e-07 -0.09788229165853385 +1.4934 0.7033548053671357 0.7033538644320452 3.1014256339501056e-07 -0.09788292816891891 +1.4935 0.703355940049768 0.7033549914849746 3.135600367687452e-07 -0.09788356449003703 +1.4936 0.7033570744298427 0.7033561181642933 3.16895142495055e-07 -0.09788420062194331 +1.4937 0.7033582085065699 0.7033572444709901 3.2014714255318433e-07 -0.09788483656469271 +1.4938000000000002 0.7033593422791526 0.7033583704060609 3.233153181708692e-07 -0.09788547231834031 +1.4939 0.703360475746786 0.7033594959705094 3.263989699076042e-07 -0.09788610788294115 +1.494 0.7033616089086578 0.7033606211653461 3.293974178003589e-07 -0.09788674325855018 +1.4941000000000002 0.7033627417639491 0.703361745991589 3.323100015439895e-07 -0.0978873784452223 +1.4942 0.7033638743118338 0.7033628704502624 3.3513608060226074e-07 -0.09788801344301254 +1.4943000000000002 0.7033650065514792 0.7033639945423975 3.3787503442295197e-07 -0.0978886482519758 +1.4944000000000002 0.7033661384820464 0.7033651182690319 3.4052626247255136e-07 -0.09788928287216708 +1.4945 0.7033672701026906 0.7033662416312091 3.430891844444228e-07 -0.09788991730364123 +1.4946000000000002 0.7033684014125601 0.7033673646299787 3.4556324032819496e-07 -0.09789055154645313 +1.4947000000000001 0.7033695324107977 0.7033684872663961 3.4794789063180565e-07 -0.09789118560065768 +1.4948000000000001 0.7033706630965415 0.7033696095415218 3.5024261634680753e-07 -0.0978918194663098 +1.4949000000000001 0.7033717934689234 0.7033707314564224 3.524469192051072e-07 -0.0978924531434643 +1.495 0.7033729235270705 0.7033718530121686 3.545603216859039e-07 -0.09789308663217605 +1.4951 0.7033740532701047 0.7033729742098365 3.5658236720303993e-07 -0.0978937199324998 +1.4952 0.7033751826971439 0.7033740950505063 3.58512620132756e-07 -0.09789435304449041 +1.4953 0.7033763118073009 0.7033752155352632 3.6035066591083575e-07 -0.09789498596820266 +1.4954 0.7033774405996844 0.703376335665196 3.6209611119220053e-07 -0.09789561870369126 +1.4955 0.7033785690733996 0.703377455441398 3.637485838856036e-07 -0.09789625125101108 +1.4956 0.7033796972275475 0.7033785748649655 3.653077331675081e-07 -0.09789688361021676 +1.4957 0.7033808250612255 0.703379693936999 3.667732297110704e-07 -0.09789751578136306 +1.4958000000000002 0.7033819525735285 0.7033808126586019 3.6814476560981246e-07 -0.09789814776450481 +1.4959 0.7033830797635472 0.7033819310308802 3.6942205452333843e-07 -0.09789877955969654 +1.496 0.7033842066303703 0.7033830490549433 3.706048316912125e-07 -0.09789941116699305 +1.4961000000000002 0.7033853331730836 0.7033841667319026 3.71692854057859e-07 -0.09790004258644891 +1.4962 0.7033864593907704 0.7033852840628725 3.726859001892957e-07 -0.09790067381811884 +1.4963000000000002 0.7033875852825124 0.7033864010489688 3.735837705021172e-07 -0.09790130486205748 +1.4964000000000002 0.7033887108473886 0.7033875176913096 3.743862871455339e-07 -0.0979019357183194 +1.4965 0.7033898360844768 0.7033886339910143 3.7509329407769965e-07 -0.09790256638695922 +1.4966000000000002 0.7033909609928537 0.7033897499492037 3.757046571559175e-07 -0.09790319686803158 +1.4967000000000001 0.703392085571594 0.703390865567 3.7622026406725073e-07 -0.09790382716159103 +1.4968000000000001 0.7033932098197722 0.7033919808455265 3.7664002445342293e-07 -0.09790445726769215 +1.4969000000000001 0.7033943337364613 0.7033930957859065 3.7696386983449015e-07 -0.09790508718638943 +1.497 0.7033954573207346 0.7033942103892641 3.771917536504743e-07 -0.09790571691773746 +1.4971 0.7033965805716645 0.7033953246567236 3.773236512752409e-07 -0.09790634646179071 +1.4972 0.7033977034883239 0.7033964385894094 3.773595599956825e-07 -0.0979069758186037 +1.4973 0.7033988260697854 0.7033975521884452 3.772994990325351e-07 -0.09790760498823095 +1.4974 0.7033999483151224 0.7033986654549551 3.771435095265008e-07 -0.0979082339707269 +1.4975 0.7034010702234088 0.7033997783900614 3.76891654489675e-07 -0.09790886276614603 +1.4976 0.7034021917937195 0.7034008909948859 3.7654401882636357e-07 -0.09790949137454275 +1.4977 0.7034033130251303 0.7034020032705497 3.7610070928451034e-07 -0.09791011979597146 +1.4978000000000002 0.7034044339167189 0.7034031152181717 3.7556185442100265e-07 -0.09791074803048666 +1.4979 0.7034055544675641 0.7034042268388694 3.749276045808547e-07 -0.09791137607814268 +1.498 0.7034066746767467 0.7034053381337584 3.741981318486354e-07 -0.09791200393899392 +1.4981000000000002 0.7034077945433492 0.7034064491039524 3.7337363000683466e-07 -0.09791263161309471 +1.4982 0.7034089140664576 0.7034075597505625 3.724543144942305e-07 -0.09791325910049947 +1.4983000000000002 0.7034100332451588 0.7034086700746973 3.71440422322622e-07 -0.09791388640126247 +1.4984000000000002 0.7034111520785439 0.7034097800774628 3.7033221204907374e-07 -0.09791451351543809 +1.4985 0.703412270565706 0.7034108897599615 3.691299636787715e-07 -0.09791514044308063 +1.4986000000000002 0.7034133887057417 0.7034119991232927 3.678339786511442e-07 -0.09791576718424432 +1.4987000000000001 0.7034145064977515 0.7034131081685524 3.6644457968026956e-07 -0.09791639373898348 +1.4988000000000001 0.7034156239408391 0.7034142168968331 3.6496211073405727e-07 -0.09791702010735243 +1.4989000000000001 0.703416741034112 0.7034153253092226 3.6338693695792124e-07 -0.09791764628940525 +1.499 0.7034178577766821 0.7034164334068052 3.617194445429406e-07 -0.09791827228519626 +1.4991 0.7034189741676655 0.7034175411906607 3.5996004068422627e-07 -0.09791889809477972 +1.4992 0.7034200902061831 0.7034186486618637 3.5810915340050986e-07 -0.09791952371820974 +1.4993 0.7034212058913604 0.7034197558214845 3.5616723152720464e-07 -0.09792014915554054 +1.4994 0.7034223212223278 0.7034208626705886 3.5413474452905547e-07 -0.0979207744068263 +1.4995 0.7034234361982215 0.7034219692102355 3.520121824723832e-07 -0.0979213994721212 +1.4996 0.7034245508181824 0.7034230754414798 3.4980005580997897e-07 -0.09792202435147936 +1.4997 0.7034256650813577 0.7034241813653697 3.474988953047764e-07 -0.09792264904495487 +1.4998000000000002 0.7034267789869 0.703425286982948 3.4510925192576813e-07 -0.09792327355260191 +1.4999 0.7034278925339681 0.7034263922952515 3.426316966745335e-07 -0.09792389787447452 +1.5 0.7034290057217274 0.7034274973033094 3.4006682046033854e-07 -0.09792452201062672 +1.5001000000000002 0.7034301185493494 0.7034286020081464 3.3741523398911344e-07 -0.09792514596111264 +1.5002 0.7034312310160128 0.7034297064107784 3.3467756761079714e-07 -0.09792576972598634 +1.5003000000000002 0.7034323431209031 0.7034308105122157 3.318544711181093e-07 -0.09792639330530184 +1.5004000000000002 0.7034334548632128 0.7034319143134606 3.289466136424668e-07 -0.09792701669911323 +1.5005 0.7034345662421417 0.7034330178155086 3.259546834805116e-07 -0.09792763990747444 +1.5006000000000002 0.7034356772568973 0.7034341210193465 3.2287938794839377e-07 -0.09792826293043938 +1.5007000000000001 0.703436787906695 0.7034352239259547 3.1972145320829926e-07 -0.09792888576806218 +1.5008000000000001 0.7034378981907575 0.7034363265363047 3.1648162404640523e-07 -0.09792950842039669 +1.5009000000000001 0.7034390081083166 0.7034374288513598 3.131606637896134e-07 -0.0979301308874969 +1.501 0.7034401176586119 0.7034385308720756 3.097593540904442e-07 -0.09793075316941674 +1.5011 0.7034412268408915 0.7034396325993981 3.062784946425423e-07 -0.0979313752662101 +1.5012 0.7034423356544124 0.7034407340342651 3.027189031945543e-07 -0.09793199717793086 +1.5013 0.7034434440984405 0.7034418351776057 2.9908141514073394e-07 -0.097932618904633 +1.5014 0.703444552172251 0.7034429360303391 2.9536688349318663e-07 -0.0979332404463703 +1.5015 0.7034456598751279 0.7034440365933758 2.915761785973747e-07 -0.09793386180319669 +1.5016 0.7034467672063649 0.7034451368676163 2.877101879586452e-07 -0.09793448297516591 +1.5017 0.7034478741652657 0.7034462368539516 2.8376981603406293e-07 -0.09793510396233185 +1.5018000000000002 0.7034489807511434 0.7034473365532627 2.7975598397567136e-07 -0.09793572476474828 +1.5019 0.7034500869633216 0.7034484359664208 2.756696294986538e-07 -0.09793634538246906 +1.502 0.7034511928011331 0.7034495350942864 2.7151170659683865e-07 -0.0979369658155479 +1.5021000000000002 0.7034522982639221 0.7034506339377102 2.6728318532759365e-07 -0.09793758606403857 +1.5022 0.7034534033510431 0.7034517324975317 2.6298505161059804e-07 -0.09793820612799486 +1.5023000000000002 0.703454508061861 0.70345283077458 2.5861830697110344e-07 -0.0979388260074705 +1.5024000000000002 0.7034556123957518 0.7034539287696732 2.5418396833870593e-07 -0.09793944570251917 +1.5025 0.7034567163521024 0.7034550264836184 2.496830677975459e-07 -0.09794006521319464 +1.5026000000000002 0.7034578199303109 0.703456123917211 2.451166523434467e-07 -0.09794068453955052 +1.5027000000000001 0.7034589231297865 0.7034572210712358 2.404857835924812e-07 -0.09794130368164052 +1.5028000000000001 0.7034600259499505 0.7034583179464655 2.3579153762831595e-07 -0.09794192263951829 +1.5029000000000001 0.7034611283902353 0.7034594145436615 2.3103500470383898e-07 -0.0979425414132375 +1.503 0.7034622304500853 0.7034605108635723 2.2621728895666493e-07 -0.0979431600028517 +1.5031 0.7034633321289571 0.7034616069069359 2.2133950824260173e-07 -0.09794377840841462 +1.5032 0.7034644334263189 0.7034627026744775 2.164027937540114e-07 -0.09794439662997984 +1.5033 0.7034655343416512 0.7034637981669098 2.1140828986715432e-07 -0.09794501466760087 +1.5034 0.703466634874447 0.7034648933849332 2.0635715380912245e-07 -0.09794563252133133 +1.5035 0.703467735024212 0.7034659883292361 2.0125055544273351e-07 -0.09794625019122481 +1.5036 0.7034688347904638 0.703467083000493 1.9608967692999468e-07 -0.09794686767733475 +1.5037 0.7034699341727337 0.7034681773993671 1.90875712541283e-07 -0.09794748497971478 +1.5038000000000002 0.7034710331705654 0.7034692715265074 1.856098682979923e-07 -0.09794810209841837 +1.5039 0.7034721317835151 0.7034703653825507 1.8029336174354982e-07 -0.09794871903349896 +1.504 0.7034732300111531 0.7034714589681201 1.7492742164851305e-07 -0.0979493357850101 +1.5041000000000002 0.7034743278530624 0.7034725522838259 1.6951328770872798e-07 -0.09794995235300524 +1.5042 0.7034754253088393 0.7034736453302644 1.6405221030246775e-07 -0.09795056873753787 +1.5043000000000002 0.7034765223780941 0.7034747381080187 1.585454501677741e-07 -0.0979511849386614 +1.5044000000000002 0.7034776190604497 0.7034758306176583 1.5299427811102384e-07 -0.09795180095642919 +1.5045 0.7034787153555435 0.703476922859739 1.4739997474325084e-07 -0.09795241679089473 +1.5046000000000002 0.7034798112630263 0.7034780148348025 1.4176383013667082e-07 -0.09795303244211133 +1.5047000000000001 0.7034809067825627 0.7034791065433771 1.3608714356447282e-07 -0.09795364791013242 +1.5048000000000001 0.7034820019138317 0.7034801979859765 1.30371223219794e-07 -0.09795426319501133 +1.5049000000000001 0.7034830966565261 0.7034812891631004 1.2461738584795823e-07 -0.09795487829680144 +1.505 0.7034841910103526 0.703482380075235 1.1882695648973707e-07 -0.0979554932155561 +1.5051 0.7034852849750326 0.7034834707228513 1.1300126820379397e-07 -0.09795610795132859 +1.5052 0.7034863785503014 0.7034845611064063 1.0714166167463679e-07 -0.09795672250417221 +1.5053 0.703487471735909 0.7034856512263425 1.0124948499404263e-07 -0.09795733687414027 +1.5054 0.7034885645316196 0.7034867410830881 9.5326093289827e-08 -0.09795795106128598 +1.5055 0.7034896569372122 0.7034878306770566 8.937284843441029e-08 -0.09795856506566272 +1.5056 0.70349074895248 0.7034889200086465 8.339111874297589e-08 -0.09795917888732363 +1.5057 0.7034918405772315 0.7034900090782419 7.738227865775049e-08 -0.09795979252632198 +1.5058000000000002 0.7034929318112895 0.7034910978862121 7.134770841320248e-08 -0.09796040598271094 +1.5059 0.7034940226544915 0.7034921864329117 6.52887937237917e-08 -0.0979610192565438 +1.506 0.7034951131066899 0.70349327471868 5.920692548733175e-08 -0.09796163234787361 +1.5061000000000002 0.7034962031677525 0.7034943627438419 5.3103499438045265e-08 -0.0979622452567537 +1.5062 0.7034972928375615 0.7034954505087065 4.69799158481915e-08 -0.09796285798323712 +1.5063000000000002 0.7034983821160141 0.7034965380135686 4.083757918979525e-08 -0.09796347052737699 +1.5064000000000002 0.7034994710030227 0.7034976252587075 3.467789782760078e-08 -0.09796408288922648 +1.5065 0.7035005594985149 0.7034987122443875 2.8502283691209107e-08 -0.0979646950688387 +1.5066000000000002 0.7035016476024332 0.7034997989708579 2.231215194027636e-08 -0.09796530706626672 +1.5067000000000002 0.7035027353147352 0.7035008854383527 1.610892065313091e-08 -0.09796591888156367 +1.5068000000000001 0.7035038226353938 0.7035019716470905 9.894010505849538e-09 -0.09796653051478256 +1.5069000000000001 0.703504909564397 0.7035030575972747 3.668844431384266e-09 -0.0979671419659765 +1.507 0.7035059961017482 0.7035041432890939 -2.5651526935552282e-09 -0.09796775323519846 +1.5071 0.7035070822474655 0.703505228722721 -8.806554379833798e-09 -0.0979683643225015 +1.5072 0.7035081680015828 0.7035063138983135 -1.5053932849850432e-08 -0.09796897522793861 +1.5073 0.703509253364149 0.7035073988160138 -2.1305859368436764e-08 -0.09796958595156278 +1.5074 0.7035103383352284 0.7035084834759491 -2.7560904560745142e-08 -0.09797019649342702 +1.5075 0.7035114229149002 0.7035095678782313 -3.381763874835131e-08 -0.09797080685358427 +1.5076 0.7035125071032594 0.7035106520229566 -4.0074632272021384e-08 -0.09797141703208749 +1.5077 0.7035135909004155 0.7035117359102062 -4.6330455816321996e-08 -0.09797202702898958 +1.5078000000000003 0.7035146743064942 0.7035128195400461 -5.25836807384588e-08 -0.09797263684434346 +1.5079 0.7035157573216354 0.7035139029125266 -5.883287939570554e-08 -0.09797324647820205 +1.508 0.703516839945995 0.7035149860276834 -6.507662546773735e-08 -0.09797385593061825 +1.5081000000000002 0.7035179221797441 0.7035160688855364 -7.131349428297559e-08 -0.09797446520164493 +1.5082 0.7035190040230681 0.7035171514860903 -7.754206314720957e-08 -0.09797507429133495 +1.5083000000000002 0.7035200854761687 0.7035182338293349 -8.376091166408667e-08 -0.09797568319974113 +1.5084000000000002 0.7035211665392618 0.7035193159152442 -8.996862205755407e-08 -0.09797629192691627 +1.5085 0.703522247212579 0.7035203977437781 -9.616377950449201e-08 -0.09797690047291328 +1.5086000000000002 0.7035233274963668 0.7035214793148803 -1.0234497244219348e-07 -0.09797750883778487 +1.5087000000000002 0.7035244073908866 0.7035225606284803 -1.085107929031659e-07 -0.09797811702158392 +1.5088000000000001 0.7035254868964146 0.7035236416844919 -1.1465983682651393e-07 -0.09797872502436311 +1.5089000000000001 0.7035265660132424 0.7035247224828143 -1.2079070438320016e-07 -0.09797933284617523 +1.509 0.7035276447416761 0.7035258030233316 -1.269020003004384e-07 -0.09797994048707305 +1.5091 0.7035287230820367 0.7035268833059131 -1.3299233415399458e-07 -0.09798054794710923 +1.5092 0.7035298010346602 0.703527963330413 -1.390603207220703e-07 -0.0979811552263365 +1.5093 0.7035308785998973 0.7035290430966716 -1.4510458026285866e-07 -0.09798176232480764 +1.5094 0.7035319557781128 0.7035301226045132 -1.5112373885975416e-07 -0.0979823692425752 +1.5095 0.7035330325696867 0.7035312018537488 -1.5711642871625575e-07 -0.09798297597969198 +1.5096 0.7035341089750131 0.7035322808441737 -1.6308128846995174e-07 -0.09798358253621055 +1.5097 0.7035351849945012 0.7035333595755691 -1.6901696349262696e-07 -0.09798418891218352 +1.5098000000000003 0.7035362606285737 0.703534438047702 -1.749221062233297e-07 -0.09798479510766359 +1.5099 0.7035373358776683 0.703535516260325 -1.807953764407233e-07 -0.09798540112270333 +1.51 0.7035384107422367 0.703536594213176 -1.866354415909488e-07 -0.0979860069573554 +1.5101000000000002 0.7035394852227443 0.7035376719059794 -1.9244097708079333e-07 -0.0979866126116723 +1.5102 0.7035405593196711 0.7035387493384452 -1.982106666159611e-07 -0.09798721808570664 +1.5103000000000002 0.7035416330335107 0.703539826510269 -2.039432023988319e-07 -0.09798782337951094 +1.5104000000000002 0.7035427063647707 0.7035409034211333 -2.0963728553785588e-07 -0.09798842849313773 +1.5105 0.7035437793139724 0.7035419800707059 -2.1529162628000642e-07 -0.09798903342663953 +1.5106000000000002 0.7035448518816505 0.7035430564586419 -2.2090494431609153e-07 -0.0979896381800689 +1.5107000000000002 0.7035459240683541 0.7035441325845819 -2.2647596907218737e-07 -0.09799024275347828 +1.5108000000000001 0.7035469958746448 0.7035452084481535 -2.320034400045412e-07 -0.09799084714692015 +1.5109000000000001 0.7035480673010974 0.7035462840489709 -2.374861068528411e-07 -0.097991451360447 +1.511 0.7035491383483008 0.7035473593866348 -2.429227299871606e-07 -0.09799205539411125 +1.5111 0.7035502090168566 0.7035484344607331 -2.483120806091865e-07 -0.09799265924796532 +1.5112 0.7035512793073794 0.7035495092708404 -2.536529410991639e-07 -0.09799326292206172 +1.5113 0.7035523492204963 0.7035505838165182 -2.5894410523100153e-07 -0.09799386641645273 +1.5114 0.7035534187568474 0.7035516580973158 -2.641843784879916e-07 -0.09799446973119078 +1.5115 0.7035544879170857 0.7035527321127695 -2.6937257831954886e-07 -0.0979950728663283 +1.5116 0.7035555567018763 0.703553805862403 -2.745075343944803e-07 -0.09799567582191764 +1.5117 0.7035566251118968 0.7035548793457278 -2.7958808890629627e-07 -0.09799627859801112 +1.5118000000000003 0.7035576931478367 0.7035559525622429 -2.846130967883165e-07 -0.09799688119466105 +1.5119 0.7035587608103978 0.7035570255114354 -2.8958142597387826e-07 -0.09799748361191973 +1.512 0.7035598281002939 0.7035580981927807 -2.944919576981786e-07 -0.09799808584983959 +1.5121000000000002 0.7035608950182504 0.7035591706057418 -2.9934358667174643e-07 -0.09799868790847278 +1.5122 0.7035619615650044 0.7035602427497704 -3.041352214239179e-07 -0.09799928978787165 +1.5123000000000002 0.7035630277413042 0.7035613146243063 -3.0886578449018653e-07 -0.09799989148808835 +1.5124000000000002 0.7035640935479099 0.7035623862287781 -3.1353421264118664e-07 -0.09800049300917524 +1.5125 0.7035651589855927 0.703563457562604 -3.181394571394325e-07 -0.09800109435118452 +1.5126000000000002 0.7035662240551341 0.7035645286251897 -3.2268048401340454e-07 -0.0980016955141684 +1.5127000000000002 0.7035672887573277 0.7035655994159311 -3.2715627425877747e-07 -0.09800229649817908 +1.5128000000000001 0.7035683530929766 0.7035666699342127 -3.3156582402577017e-07 -0.09800289730326872 +1.5129000000000001 0.7035694170628949 0.7035677401794087 -3.359081448967016e-07 -0.09800349792948951 +1.513 0.7035704806679073 0.7035688101508832 -3.401822641080354e-07 -0.09800409837689363 +1.5131000000000001 0.7035715439088484 0.7035698798479896 -3.443872247307911e-07 -0.09800469864553324 +1.5132 0.7035726067865624 0.7035709492700711 -3.4852208595503864e-07 -0.09800529873546035 +1.5133 0.7035736693019041 0.7035720184164616 -3.5258592320785986e-07 -0.09800589864672715 +1.5134 0.7035747314557378 0.7035730872864848 -3.5657782841008734e-07 -0.09800649837938576 +1.5135 0.7035757932489369 0.7035741558794553 -3.604969101844713e-07 -0.09800709793348825 +1.5136 0.7035768546823843 0.7035752241946778 -3.643422940707852e-07 -0.09800769730908665 +1.5137 0.7035779157569721 0.7035762922314484 -3.6811312264378726e-07 -0.09800829650623304 +1.5138000000000003 0.7035789764736013 0.7035773599890536 -3.718085557630202e-07 -0.09800889552497949 +1.5139 0.7035800368331815 0.703578427466772 -3.7542777078097833e-07 -0.09800949436537801 +1.514 0.703581096836631 0.7035794946638727 -3.789699626957632e-07 -0.09801009302748057 +1.5141000000000002 0.7035821564848765 0.7035805615796166 -3.82434344317617e-07 -0.09801069151133922 +1.5142 0.7035832157788527 0.7035816282132564 -3.858201464562727e-07 -0.0980112898170059 +1.5143000000000002 0.7035842747195027 0.7035826945640372 -3.891266181013653e-07 -0.0980118879445326 +1.5144000000000002 0.7035853333077766 0.7035837606311957 -3.9235302656120963e-07 -0.09801248589397127 +1.5145 0.7035863915446325 0.7035848264139613 -3.9549865768484516e-07 -0.09801308366537383 +1.5146000000000002 0.7035874494310366 0.7035858919115556 -3.9856281592448584e-07 -0.09801368125879226 +1.5147 0.703588506967961 0.7035869571231936 -4.0154482458532037e-07 -0.09801427867427842 +1.5148000000000001 0.7035895641563856 0.7035880220480828 -4.044440259157178e-07 -0.09801487591188421 +1.5149000000000001 0.7035906209972971 0.7035890866854233 -4.072597813153944e-07 -0.09801547297166147 +1.515 0.7035916774916879 0.7035901510344098 -4.0999147137704695e-07 -0.09801606985366212 +1.5151000000000001 0.7035927336405583 0.7035912150942303 -4.1263849607370284e-07 -0.09801666655793807 +1.5152 0.7035937894449131 0.7035922788640658 -4.152002749113759e-07 -0.09801726308454108 +1.5153 0.7035948449057642 0.7035933423430918 -4.17676247074783e-07 -0.09801785943352295 +1.5154 0.7035959000241285 0.703594405530478 -4.20065871441222e-07 -0.09801845560493551 +1.5155 0.7035969548010295 0.7035954684253887 -4.223686268234328e-07 -0.09801905159883059 +1.5156 0.7035980092374945 0.7035965310269827 -4.245840120042921e-07 -0.09801964741525997 +1.5157 0.7035990633345572 0.7035975933344133 -4.267115458964077e-07 -0.09802024305427537 +1.5158000000000003 0.7036001170932549 0.7035986553468296 -4.2875076759069097e-07 -0.09802083851592852 +1.5159 0.703601170514631 0.7035997170633754 -4.307012364951346e-07 -0.09802143380027124 +1.516 0.7036022235997321 0.7036007784831901 -4.32562532438896e-07 -0.09802202890735515 +1.5161000000000002 0.7036032763496101 0.7036018396054093 -4.343342557347474e-07 -0.09802262383723202 +1.5162 0.70360432876532 0.7036029004291637 -4.3601602728315925e-07 -0.09802321858995355 +1.5163000000000002 0.7036053808479208 0.7036039609535811 -4.3760748866944477e-07 -0.09802381316557142 +1.5164000000000002 0.7036064325984754 0.7036050211777849 -4.3910830213600427e-07 -0.09802440756413724 +1.5165 0.7036074840180497 0.7036060811008954 -4.4051815078355316e-07 -0.09802500178570268 +1.5166000000000002 0.703608535107713 0.7036071407220299 -4.4183673857806083e-07 -0.09802559583031942 +1.5167 0.7036095858685374 0.7036082000403029 -4.43063790454834e-07 -0.09802618969803904 +1.5168000000000001 0.7036106363015973 0.7036092590548255 -4.4419905231157797e-07 -0.09802678338891314 +1.5169000000000001 0.70361168640797 0.7036103177647068 -4.4524229109166313e-07 -0.09802737690299337 +1.517 0.7036127361887349 0.7036113761690539 -4.4619329483269743e-07 -0.09802797024033126 +1.5171000000000001 0.703613785644973 0.7036124342669713 -4.470518727081596e-07 -0.09802856340097837 +1.5172 0.7036148347777675 0.7036134920575617 -4.478178550898493e-07 -0.09802915638498623 +1.5173 0.7036158835882032 0.7036145495399267 -4.484910935340092e-07 -0.09802974919240641 +1.5174 0.703616932077366 0.7036156067131664 -4.4907146080908067e-07 -0.09803034182329044 +1.5175 0.7036179802463427 0.7036166635763791 -4.495588509789705e-07 -0.09803093427768977 +1.5176 0.7036190280962212 0.7036177201286631 -4.4995317933366197e-07 -0.09803152655565595 +1.5177 0.7036200756280903 0.7036187763691156 -4.5025438251411476e-07 -0.09803211865724043 +1.5178000000000003 0.7036211228430385 0.7036198322968332 -4.504624184081818e-07 -0.09803271058249467 +1.5179 0.7036221697421549 0.7036208879109128 -4.5057726624775363e-07 -0.09803330233147012 +1.518 0.7036232163265286 0.7036219432104507 -4.5059892650467503e-07 -0.09803389390421818 +1.5181000000000002 0.7036242625972482 0.7036229981945441 -4.5052742100870624e-07 -0.09803448530079038 +1.5182 0.7036253085554018 0.7036240528622898 -4.503627928365006e-07 -0.09803507652123798 +1.5183000000000002 0.7036263542020771 0.7036251072127859 -4.501051063324213e-07 -0.09803566756561244 +1.5184000000000002 0.7036273995383604 0.7036261612451318 -4.497544470738468e-07 -0.09803625843396517 +1.5185 0.7036284445653371 0.7036272149584268 -4.493109219128044e-07 -0.0980368491263475 +1.5186000000000002 0.7036294892840909 0.7036282683517725 -4.4877465884413104e-07 -0.09803743964281073 +1.5187 0.7036305336957038 0.7036293214242721 -4.4814580701241225e-07 -0.09803802998340623 +1.5188000000000001 0.7036315778012567 0.7036303741750302 -4.4742453670504334e-07 -0.09803862014818536 +1.5189000000000001 0.7036326216018275 0.7036314266031536 -4.466110392620237e-07 -0.09803921013719935 +1.519 0.7036336650984922 0.7036324787077517 -4.4570552704126243e-07 -0.09803979995049958 +1.5191000000000001 0.7036347082923242 0.703633530487936 -4.4470823337000587e-07 -0.09804038958813727 +1.5192 0.7036357511843938 0.7036345819428206 -4.4361941251708226e-07 -0.09804097905016362 +1.5193 0.703636793775769 0.703635633071523 -4.4243933953330705e-07 -0.09804156833662997 +1.5194 0.703637836067514 0.7036366838731636 -4.4116831027923853e-07 -0.09804215744758754 +1.5195 0.7036388780606895 0.7036377343468663 -4.3980664133497216e-07 -0.09804274638308749 +1.5196 0.703639919756353 0.7036387844917583 -4.3835466986830163e-07 -0.09804333514318106 +1.5197 0.7036409611555583 0.7036398343069712 -4.36812753558391e-07 -0.0980439237279195 +1.5198000000000003 0.7036420022593544 0.7036408837916399 -4.351812705957747e-07 -0.09804451213735389 +1.5199 0.7036430430687861 0.7036419329449041 -4.3346061954357973e-07 -0.09804510037153541 +1.52 0.7036440835848942 0.7036429817659079 -4.3165121914323645e-07 -0.09804568843051527 +1.5201000000000002 0.7036451238087144 0.7036440302538001 -4.297535083908066e-07 -0.09804627631434458 +1.5202 0.7036461637412771 0.7036450784077339 -4.277679462524886e-07 -0.09804686402307436 +1.5203000000000002 0.7036472033836082 0.7036461262268687 -4.256950117131897e-07 -0.09804745155675582 +1.5204000000000002 0.7036482427367281 0.7036471737103682 -4.235352035406037e-07 -0.09804803891544006 +1.5205 0.7036492818016511 0.703648220857402 -4.212890402296998e-07 -0.0980486260991781 +1.5206000000000002 0.7036503205793863 0.7036492676671455 -4.189570598639447e-07 -0.09804921310802099 +1.5207 0.7036513590709362 0.70365031413878 -4.1653981997652467e-07 -0.0980497999420198 +1.5208000000000002 0.7036523972772976 0.7036513602714931 -4.140378974532011e-07 -0.09805038660122556 +1.5209000000000001 0.7036534351994606 0.7036524060644784 -4.114518883241436e-07 -0.0980509730856893 +1.521 0.7036544728384088 0.7036534515169368 -4.0878240768066343e-07 -0.09805155939546202 +1.5211000000000001 0.7036555101951188 0.7036544966280751 -4.0603008956419107e-07 -0.09805214553059471 +1.5212 0.7036565472705605 0.7036555413971075 -4.0319558668178157e-07 -0.09805273149113833 +1.5213 0.7036575840656962 0.7036565858232557 -4.002795703991757e-07 -0.09805331727714385 +1.5214 0.7036586205814809 0.7036576299057482 -3.9728273045630536e-07 -0.09805390288866223 +1.5215 0.7036596568188621 0.7036586736438213 -3.942057749464767e-07 -0.09805448832574439 +1.5216 0.7036606927787796 0.7036597170367193 -3.9104943001799786e-07 -0.09805507358844127 +1.5217 0.7036617284621645 0.7036607600836938 -3.8781443978397334e-07 -0.09805565867680373 +1.5218000000000003 0.7036627638699404 0.7036618027840054 -3.8450156608638153e-07 -0.09805624359088269 +1.5219 0.7036637990030229 0.703662845136922 -3.8111158837811354e-07 -0.09805682833072904 +1.522 0.7036648338623177 0.7036638871417212 -3.776453035078675e-07 -0.09805741289639361 +1.5221000000000002 0.7036658684487228 0.7036649287976884 -3.74103525498104e-07 -0.09805799728792725 +1.5222 0.7036669027631268 0.7036659701041181 -3.7048708543402364e-07 -0.09805858150538078 +1.5223000000000002 0.7036679368064096 0.703667011060314 -3.667968312484615e-07 -0.09805916554880502 +1.5224000000000002 0.7036689705794418 0.7036680516655892 -3.6303362743045353e-07 -0.0980597494182509 +1.5225 0.7036700040830837 0.7036690919192659 -3.591983549489086e-07 -0.09806033311376902 +1.5226000000000002 0.7036710373181868 0.7036701318206757 -3.5529191097505297e-07 -0.09806091663541025 +1.5227 0.7036720702855928 0.7036711713691605 -3.5131520866732435e-07 -0.09806149998322537 +1.5228000000000002 0.7036731029861327 0.7036722105640718 -3.4726917706034977e-07 -0.09806208315726504 +1.5229000000000001 0.7036741354206284 0.7036732494047713 -3.431547606763674e-07 -0.09806266615758012 +1.523 0.7036751675898905 0.7036742878906306 -3.3897291944195995e-07 -0.09806324898422122 +1.5231000000000001 0.7036761994947198 0.7036753260210321 -3.3472462841743766e-07 -0.09806383163723909 +1.5232 0.7036772311359063 0.7036763637953691 -3.3041087756091603e-07 -0.09806441411668443 +1.5233 0.7036782625142288 0.7036774012130451 -3.2603267149933224e-07 -0.09806499642260791 +1.5234 0.7036792936304559 0.7036784382734744 -3.2159102936191175e-07 -0.0980655785550602 +1.5235 0.7036803244853442 0.7036794749760826 -3.170869844193458e-07 -0.09806616051409191 +1.5236 0.7036813550796401 0.7036805113203066 -3.125215839311357e-07 -0.09806674229975373 +1.5237 0.7036823854140777 0.7036815473055945 -3.0789588892354836e-07 -0.09806732391209624 +1.5238000000000003 0.7036834154893803 0.7036825829314057 -3.032109738079769e-07 -0.09806790535117006 +1.5239 0.703684445306259 0.7036836181972111 -2.984679263393075e-07 -0.09806848661702576 +1.524 0.7036854748654131 0.7036846531024943 -2.9366784713366623e-07 -0.09806906770971394 +1.5241000000000002 0.7036865041675304 0.7036856876467497 -2.8881184959902995e-07 -0.09806964862928519 +1.5242 0.7036875332132861 0.7036867218294841 -2.839010596021596e-07 -0.09807022937578996 +1.5243000000000002 0.7036885620033437 0.7036877556502168 -2.7893661521533053e-07 -0.0980708099492789 +1.5244000000000002 0.7036895905383539 0.7036887891084791 -2.739196664006127e-07 -0.09807139034980249 +1.5245 0.7036906188189553 0.7036898222038146 -2.688513748641541e-07 -0.09807197057741124 +1.5246000000000002 0.7036916468457735 0.7036908549357792 -2.637329136571942e-07 -0.09807255063215559 +1.5247 0.7036926746194219 0.7036918873039424 -2.5856546700259164e-07 -0.09807313051408609 +1.5248000000000002 0.7036937021405009 0.7036929193078856 -2.5335022994441014e-07 -0.09807371022325317 +1.5249000000000001 0.703694729409598 0.7036939509472032 -2.4808840815016e-07 -0.09807428975970736 +1.525 0.7036957564272872 0.7036949822215028 -2.4278121756038384e-07 -0.098074869123499 +1.5251000000000001 0.7036967831941296 0.703696013130405 -2.3742988415620392e-07 -0.09807544831467849 +1.5252000000000001 0.7036978097106737 0.7036970436735436 -2.3203564365054108e-07 -0.09807602733329629 +1.5253 0.7036988359774541 0.7036980738505657 -2.2659974121749804e-07 -0.09807660617940281 +1.5254 0.7036998619949915 0.7036991036611321 -2.2112343119398692e-07 -0.09807718485304842 +1.5255 0.7037008877637937 0.7037001331049163 -2.1560797679523458e-07 -0.09807776335428345 +1.5256 0.7037019132843549 0.7037011621816063 -2.10054649830288e-07 -0.09807834168315831 +1.5257 0.7037029385571554 0.7037021908909029 -2.0446473038976398e-07 -0.09807891983972328 +1.5258000000000003 0.7037039635826614 0.7037032192325215 -1.9883950656829352e-07 -0.0980794978240287 +1.5259 0.7037049883613257 0.7037042472061908 -1.9318027418002703e-07 -0.09808007563612489 +1.526 0.7037060128935866 0.7037052748116535 -1.874883364186286e-07 -0.09808065327606208 +1.5261000000000002 0.703707037179869 0.7037063020486665 -1.8176500361094527e-07 -0.09808123074389068 +1.5262 0.7037080612205835 0.7037073289170004 -1.7601159283883727e-07 -0.0980818080396609 +1.5263000000000002 0.703709085016126 0.7037083554164403 -1.7022942774488903e-07 -0.09808238516342295 +1.5264000000000002 0.7037101085668787 0.7037093815467854 -1.644198381143408e-07 -0.09808296211522714 +1.5265 0.7037111318732088 0.703710407307849 -1.5858415966171768e-07 -0.0980835388951236 +1.5266000000000002 0.7037121549354702 0.703711432699459 -1.5272373365786407e-07 -0.09808411550316262 +1.5267 0.7037131777540018 0.7037124577214574 -1.4683990665759206e-07 -0.0980846919393944 +1.5268000000000002 0.7037142003291277 0.7037134823737006 -1.4093403018396178e-07 -0.09808526820386906 +1.5269000000000001 0.703715222661158 0.70371450665606 -1.35007460410827e-07 -0.09808584429663683 +1.527 0.7037162447503877 0.7037155305684206 -1.29061557862728e-07 -0.09808642021774783 +1.5271000000000001 0.7037172665970981 0.7037165541106831 -1.2309768708702873e-07 -0.09808699596725223 +1.5272000000000001 0.7037182882015545 0.7037175772827617 -1.1711721635901395e-07 -0.09808757154520009 +1.5273 0.7037193095640086 0.7037186000845863 -1.1112151734188336e-07 -0.0980881469516416 +1.5274 0.7037203306846973 0.7037196225161008 -1.0511196481093055e-07 -0.09808872218662688 +1.5275 0.7037213515638416 0.7037206445772635 -9.908993630920043e-08 -0.09808929725020589 +1.5276 0.7037223722016493 0.7037216662680483 -9.305681182916747e-08 -0.09808987214242881 +1.5277 0.7037233925983122 0.7037226875884435 -8.701397352390422e-08 -0.09809044686334564 +1.5278000000000003 0.7037244127540081 0.7037237085384519 -8.096280536187134e-08 -0.09809102141300646 +1.5279 0.7037254326688993 0.7037247291180913 -7.490469282073892e-08 -0.09809159579146126 +1.528 0.7037264523431335 0.7037257493273944 -6.884102257773833e-08 -0.09809216999876005 +1.5281000000000002 0.7037274717768438 0.7037267691664086 -6.277318218396791e-08 -0.0980927440349529 +1.5282 0.7037284909701482 0.703727788635196 -5.670255974867325e-08 -0.09809331790008972 +1.5283000000000002 0.7037295099231495 0.7037288077338342 -5.0630543618973914e-08 -0.09809389159422052 +1.5284 0.7037305286359363 0.7037298264624143 -4.455852207064896e-08 -0.09809446511739522 +1.5285 0.7037315471085819 0.7037308448210435 -3.848788298349971e-08 -0.09809503846966389 +1.5286000000000002 0.7037325653411448 0.7037318628098432 -3.242001352457297e-08 -0.09809561165107632 +1.5287 0.7037335833336686 0.7037328804289495 -2.6356299835531352e-08 -0.09809618466168248 +1.5288000000000002 0.7037346010861827 0.7037338976785139 -2.02981267133015e-08 -0.09809675750153231 +1.5289000000000001 0.7037356185987003 0.7037349145587016 -1.4246877292917876e-08 -0.09809733017067561 +1.529 0.7037366358712212 0.7037359310696936 -8.20393273670908e-09 -0.0980979026691623 +1.5291000000000001 0.7037376529037296 0.7037369472116847 -2.170671912181399e-09 -0.09809847499704222 +1.5292000000000001 0.7037386696961957 0.7037379629848852 3.851528917846181e-09 -0.09809904715436525 +1.5293 0.7037396862485739 0.70373897838952 9.86129641313005e-09 -0.09809961914118119 +1.5294 0.7037407025608051 0.7037399934258278 1.5857260457843858e-08 -0.09810019095753987 +1.5295 0.703741718632815 0.703741008094063 2.1838054487140213e-08 -0.09810076260349117 +1.5296 0.7037427344645144 0.7037420223944935 2.7802315795064092e-08 -0.09810133407908474 +1.5297 0.7037437500558004 0.7037430363274022 3.374868584073154e-08 -0.09810190538437047 +1.5298000000000003 0.7037447654065546 0.7037440498930864 3.967581056231462e-08 -0.09810247651939805 +1.5299 0.7037457805166452 0.703745063091858 4.55823406693423e-08 -0.09810304748421729 +1.53 0.7037467953859251 0.7037460759240427 5.1466931976634767e-08 -0.09810361827887787 +1.5301000000000002 0.7037478100142335 0.7037470883899812 5.73282456801244e-08 -0.09810418890342958 +1.5302 0.7037488244013947 0.7037481004900278 6.316494870726996e-08 -0.09810475935792205 +1.5303000000000002 0.7037498385472195 0.7037491122245512 6.897571396859148e-08 -0.09810532964240501 +1.5304 0.7037508524515039 0.7037501235939342 7.475922068553298e-08 -0.09810589975692811 +1.5305 0.7037518661140307 0.7037511345985736 8.051415467495715e-08 -0.0981064697015411 +1.5306000000000002 0.7037528795345676 0.7037521452388804 8.623920867353863e-08 -0.09810703947629358 +1.5307 0.703753892712869 0.7037531555152788 9.193308263613642e-08 -0.09810760908123513 +1.5308000000000002 0.7037549056486758 0.7037541654282076 9.759448397345105e-08 -0.09810817851641546 +1.5309000000000001 0.7037559183417144 0.7037551749781182 1.0322212791805119e-07 -0.09810874778188411 +1.531 0.703756930791698 0.7037561841654771 1.0881473778284745e-07 -0.09810931687769076 +1.5311000000000001 0.7037579429983261 0.7037571929907631 1.1437104523864816e-07 -0.09810988580388488 +1.5312000000000001 0.7037589549612848 0.703758201454469 1.1988979060906235e-07 -0.09811045456051616 +1.5313 0.7037599666802464 0.7037592095571008 1.2536972319662776e-07 -0.09811102314763404 +1.5314 0.7037609781548708 0.7037602172991777 1.3080960149791654e-07 -0.09811159156528819 +1.5315 0.7037619893848035 0.7037612246812319 1.3620819355394942e-07 -0.09811215981352796 +1.5316 0.7037630003696781 0.7037622317038092 1.415642771583625e-07 -0.098112727892403 +1.5317 0.7037640111091146 0.7037632383674677 1.468766401974131e-07 -0.09811329580196278 +1.5318000000000003 0.7037650216027201 0.7037642446727785 1.5214408085814646e-07 -0.09811386354225676 +1.5319 0.7037660318500891 0.7037652506203255 1.5736540799268783e-07 -0.09811443111333444 +1.532 0.7037670418508037 0.7037662562107052 1.6253944129171471e-07 -0.09811499851524523 +1.5321000000000002 0.7037680516044329 0.7037672614445263 1.6766501160711544e-07 -0.0981155657480386 +1.5322 0.7037690611105338 0.7037682663224101 1.7274096117750326e-07 -0.09811613281176401 +1.5323000000000002 0.7037700703686516 0.7037692708449903 1.7776614397169155e-07 -0.09811669970647088 +1.5324 0.7037710793783181 0.7037702750129121 1.8273942585175784e-07 -0.09811726643220856 +1.5325 0.7037720881390541 0.703771278826833 1.8765968485753848e-07 -0.09811783298902645 +1.5326000000000002 0.7037730966503684 0.7037722822874224 1.925258114945927e-07 -0.0981183993769739 +1.5327 0.7037741049117578 0.7037732853953611 1.9733670894583888e-07 -0.09811896559610034 +1.5328000000000002 0.7037751129227079 0.7037742881513418 2.0209129334911036e-07 -0.09811953164645507 +1.5329000000000002 0.7037761206826924 0.7037752905560686 2.0678849398797494e-07 -0.09812009752808745 +1.533 0.7037771281911738 0.7037762926102562 2.1142725361092407e-07 -0.09812066324104673 +1.5331000000000001 0.7037781354476037 0.7037772943146314 2.1600652859096736e-07 -0.09812122878538232 +1.5332000000000001 0.7037791424514221 0.7037782956699312 2.2052528921012726e-07 -0.09812179416114337 +1.5333 0.7037801492020591 0.7037792966769036 2.249825198849531e-07 -0.09812235936837928 +1.5334 0.7037811556989332 0.7037802973363076 2.2937721939897404e-07 -0.09812292440713927 +1.5335 0.7037821619414527 0.7037812976489126 2.337084010831103e-07 -0.09812348927747261 +1.5336 0.7037831679290153 0.7037822976154979 2.379750930966984e-07 -0.09812405397942847 +1.5337 0.7037841736610086 0.7037832972368535 2.4217633859402454e-07 -0.09812461851305615 +1.5338000000000003 0.7037851791368105 0.7037842965137793 2.463111959741249e-07 -0.09812518287840483 +1.5339 0.7037861843557882 0.7037852954470847 2.5037873907507446e-07 -0.09812574707552368 +1.534 0.7037871893173 0.7037862940375892 2.543780574168486e-07 -0.09812631110446192 +1.5341000000000002 0.703788194020694 0.7037872922861217 2.583082563470396e-07 -0.09812687496526872 +1.5342 0.7037891984653092 0.7037882901935205 2.621684572629013e-07 -0.09812743865799319 +1.5343000000000002 0.7037902026504752 0.703789287760633 2.659577978542105e-07 -0.09812800218268451 +1.5344 0.7037912065755129 0.7037902849883154 2.6967543222122803e-07 -0.09812856553939175 +1.5345 0.7037922102397338 0.7037912818774331 2.733205310898046e-07 -0.09812912872816408 +1.5346000000000002 0.7037932136424409 0.7037922784288603 2.768922820403641e-07 -0.09812969174905056 +1.5347 0.703794216782929 0.7037932746434789 2.803898896189261e-07 -0.09813025460210033 +1.5348000000000002 0.7037952196604842 0.7037942705221796 2.838125755660892e-07 -0.09813081728736239 +1.5349000000000002 0.7037962222743845 0.7037952660658613 2.871595789766257e-07 -0.09813137980488579 +1.535 0.7037972246239006 0.7037962612754302 2.904301564451983e-07 -0.09813194215471963 +1.5351000000000001 0.7037982267082943 0.7037972561518007 2.936235822814659e-07 -0.09813250433691288 +1.5352000000000001 0.7037992285268208 0.7037982506958951 2.9673914859335015e-07 -0.09813306635151464 +1.5353 0.7038002300787273 0.7037992449086422 2.9977616554377473e-07 -0.09813362819857384 +1.5354 0.7038012313632542 0.7038002387909784 3.0273396140617637e-07 -0.0981341898781395 +1.5355 0.7038022323796346 0.7038012323438466 3.05611882751855e-07 -0.09813475139026052 +1.5356 0.7038032331270951 0.703802225568197 3.0840929463038513e-07 -0.09813531273498596 +1.5357 0.7038042336048558 0.7038032184649865 3.11125580673699e-07 -0.09813587391236472 +1.5358000000000003 0.7038052338121301 0.7038042110351773 3.1376014324874246e-07 -0.09813643492244577 +1.5359 0.703806233748125 0.7038052032797388 3.163124035754361e-07 -0.09813699576527797 +1.536 0.7038072334120422 0.703806195199646 3.187818018030031e-07 -0.09813755644091028 +1.5361000000000002 0.7038082328030769 0.7038071867958794 3.211677972320137e-07 -0.09813811694939155 +1.5362 0.7038092319204193 0.7038081780694253 3.234698683560189e-07 -0.09813867729077069 +1.5363000000000002 0.7038102307632539 0.7038091690212749 3.256875130211445e-07 -0.09813923746509652 +1.5364 0.7038112293307601 0.7038101596524251 3.278202485093584e-07 -0.09813979747241794 +1.5365 0.7038122276221125 0.7038111499638775 3.29867611684187e-07 -0.09814035731278375 +1.5366000000000002 0.7038132256364806 0.7038121399566379 3.3182915903928745e-07 -0.09814091698624276 +1.5367 0.7038142233730299 0.7038131296317175 3.337044668094702e-07 -0.09814147649284385 +1.5368000000000002 0.703815220830921 0.7038141189901308 3.354931310747822e-07 -0.09814203583263571 +1.5369000000000002 0.7038162180093108 0.7038151080328974 3.371947677813236e-07 -0.09814259500566724 +1.537 0.7038172149073523 0.7038160967610395 3.388090129563537e-07 -0.0981431540119871 +1.5371000000000001 0.7038182115241944 0.7038170851755841 3.403355226805349e-07 -0.09814371285164411 +1.5372000000000001 0.7038192078589831 0.7038180732775607 3.417739732475278e-07 -0.09814427152468698 +1.5373 0.703820203910861 0.7038190610680028 3.431240610737851e-07 -0.09814483003116449 +1.5374 0.7038211996789674 0.7038200485479467 3.4438550295529113e-07 -0.09814538837112531 +1.5375 0.703822195162439 0.7038210357184304 3.4555803592878354e-07 -0.09814594654461815 +1.5376 0.7038231903604096 0.7038220225804956 3.466414175562482e-07 -0.09814650455169166 +1.5377 0.7038241852720113 0.7038230091351863 3.4763542581389695e-07 -0.09814706239239454 +1.5378000000000003 0.7038251798963733 0.7038239953835481 3.485398591268618e-07 -0.09814762006677544 +1.5379 0.7038261742326234 0.7038249813266286 3.493545364871564e-07 -0.09814817757488299 +1.538 0.7038271682798876 0.7038259669654774 3.5007929746061484e-07 -0.09814873491676589 +1.5381000000000002 0.7038281620372899 0.7038269523011451 3.507140022354638e-07 -0.0981492920924727 +1.5382 0.703829155503954 0.7038279373346836 3.512585316153838e-07 -0.09814984910205203 +1.5383000000000002 0.7038301486790016 0.7038289220671461 3.5171278702644804e-07 -0.09815040594555247 +1.5384 0.7038311415615539 0.7038299064995863 3.5207669060732805e-07 -0.09815096262302257 +1.5385 0.7038321341507319 0.7038308906330587 3.523501851329658e-07 -0.09815151913451098 +1.5386000000000002 0.7038331264456554 0.7038318744686178 3.525332341325349e-07 -0.09815207548006613 +1.5387 0.7038341184454449 0.7038328580073185 3.526258217437239e-07 -0.09815263165973667 +1.5388000000000002 0.7038351101492202 0.7038338412502158 3.526279528237586e-07 -0.09815318767357105 +1.5389000000000002 0.7038361015561018 0.7038348241983636 3.5253965293552403e-07 -0.09815374352161779 +1.539 0.7038370926652107 0.7038358068528161 3.5236096829205366e-07 -0.09815429920392543 +1.5391000000000001 0.7038380834756683 0.7038367892146264 3.5209196573571244e-07 -0.09815485472054242 +1.5392000000000001 0.7038390739865976 0.7038377712848464 3.51732732800647e-07 -0.09815541007151724 +1.5393000000000001 0.7038400641971216 0.7038387530645268 3.512833775878854e-07 -0.09815596525689826 +1.5394 0.703841054106366 0.7038397345547175 3.507440287445207e-07 -0.09815652027673405 +1.5395 0.7038420437134574 0.7038407157564659 3.5011483549840516e-07 -0.09815707513107294 +1.5396 0.7038430330175239 0.7038416966708182 3.493959675610059e-07 -0.09815762981996337 +1.5397 0.7038440220176965 0.703842677298818 3.48587615113527e-07 -0.09815818434345375 +1.5398000000000003 0.7038450107131077 0.7038436576415072 3.476899887097651e-07 -0.09815873870159246 +1.5399 0.7038459991028929 0.7038446376999248 3.467033193038649e-07 -0.09815929289442789 +1.54 0.7038469871861901 0.7038456174751067 3.456278581115413e-07 -0.09815984692200834 +1.5401000000000002 0.70384797496214 0.7038465969680865 3.44463876568446e-07 -0.09816040078438226 +1.5402 0.7038489624298867 0.7038475761798946 3.4321166632322875e-07 -0.0981609544815979 +1.5403000000000002 0.7038499495885776 0.7038485551115573 3.418715390363092e-07 -0.0981615080137036 +1.5404 0.7038509364373634 0.703849533764098 3.4044382646314375e-07 -0.09816206138074766 +1.5405 0.7038519229753988 0.7038505121385362 3.389288802599366e-07 -0.0981626145827784 +1.5406000000000002 0.7038529092018422 0.7038514902358872 3.3732707187261735e-07 -0.09816316761984406 +1.5407 0.7038538951158564 0.703852468057162 3.356387925784743e-07 -0.09816372049199287 +1.5408000000000002 0.7038548807166088 0.7038534456033674 3.338644533126822e-07 -0.09816427319927318 +1.5409000000000002 0.703855866003271 0.7038544228755053 3.3200448452952447e-07 -0.09816482574173312 +1.541 0.7038568509750196 0.7038553998745728 3.3005933615382066e-07 -0.09816537811942097 +1.5411000000000001 0.7038578356310363 0.7038563766015623 3.280294774490877e-07 -0.09816593033238497 +1.5412000000000001 0.7038588199705076 0.7038573530574603 3.259153969412121e-07 -0.09816648238067321 +1.5413000000000001 0.7038598039926263 0.7038583292432484 3.2371760226579394e-07 -0.098167034264334 +1.5414 0.7038607876965897 0.7038593051599021 3.2143662004324725e-07 -0.09816758598341543 +1.5415 0.703861771081602 0.7038602808083912 3.1907299578859405e-07 -0.09816813753796569 +1.5416 0.7038627541468728 0.7038612561896794 3.166272937032977e-07 -0.09816868892803292 +1.5417 0.703863736891618 0.703862231304724 3.1410009666138494e-07 -0.09816924015366518 +1.5418000000000003 0.7038647193150602 0.7038632061544762 3.1149200598046267e-07 -0.0981697912149107 +1.5419 0.7038657014164281 0.70386418073988 3.08803641269062e-07 -0.09817034211181748 +1.542 0.7038666831949578 0.7038651550618726 3.060356403711273e-07 -0.09817089284443364 +1.5421 0.7038676646498923 0.7038661291213848 3.0318865911621584e-07 -0.09817144341280726 +1.5422 0.7038686457804815 0.7038671029193393 3.0026337123623126e-07 -0.09817199381698642 +1.5423000000000002 0.703869626585983 0.7038680764566522 2.972604681503177e-07 -0.0981725440570192 +1.5424 0.7038706070656616 0.703869049734231 2.94180658826082e-07 -0.09817309413295354 +1.5425 0.7038715872187902 0.703870022752976 2.9102466966857143e-07 -0.09817364404483749 +1.5426000000000002 0.7038725670446496 0.7038709955137796 2.877932442149622e-07 -0.09817419379271909 +1.5427 0.7038735465425288 0.7038719680175255 2.84487143113743e-07 -0.09817474337664629 +1.5428000000000002 0.7038745257117247 0.7038729402650896 2.811071438124646e-07 -0.09817529279666709 +1.5429000000000002 0.7038755045515435 0.703873912257339 2.776540404744732e-07 -0.0981758420528295 +1.543 0.703876483061299 0.7038748839951319 2.7412864372911017e-07 -0.09817639114518141 +1.5431000000000001 0.7038774612403149 0.7038758554793179 2.705317805121177e-07 -0.0981769400737708 +1.5432000000000001 0.7038784390879231 0.7038768267107374 2.6686429386441057e-07 -0.09817748883864555 +1.5433000000000001 0.703879416603465 0.7038777976902216 2.631270427586041e-07 -0.0981780374398536 +1.5434 0.7038803937862914 0.7038787684185925 2.593209018075804e-07 -0.09817858587744287 +1.5435 0.7038813706357627 0.7038797388966622 2.554467612575495e-07 -0.09817913415146123 +1.5436 0.7038823471512484 0.703880709125233 2.5150552650232694e-07 -0.09817968226195649 +1.5437 0.7038833233321288 0.7038816791050977 2.4749811810415023e-07 -0.09818023020897657 +1.5438000000000003 0.7038842991777933 0.7038826488370389 2.434254714744899e-07 -0.09818077799256929 +1.5439 0.7038852746876423 0.7038836183218292 2.3928853666588257e-07 -0.09818132561278259 +1.544 0.7038862498610854 0.7038845875602303 2.350882781845809e-07 -0.09818187306966411 +1.5441 0.7038872246975436 0.7038855565529938 2.3082567475463112e-07 -0.09818242036326176 +1.5442 0.7038881991964485 0.7038865253008606 2.26501718998684e-07 -0.09818296749362337 +1.5443000000000002 0.7038891733572417 0.7038874938045607 2.2211741734778911e-07 -0.0981835144607966 +1.5444 0.7038901471793763 0.7038884620648134 2.1767378976383922e-07 -0.09818406126482931 +1.5445 0.7038911206623164 0.7038894300823262 2.131718694342588e-07 -0.0981846079057692 +1.5446000000000002 0.7038920938055371 0.7038903978577963 2.0861270261587905e-07 -0.098185154383664 +1.5447 0.703893066608525 0.703891365391909 2.039973483330959e-07 -0.0981857006985615 +1.5448000000000002 0.7038940390707779 0.7038923326853381 1.9932687818011163e-07 -0.09818624685050935 +1.5449000000000002 0.7038950111918054 0.7038932997387461 1.9460237602950126e-07 -0.09818679283955528 +1.545 0.7038959829711287 0.7038942665527832 1.8982493780322907e-07 -0.0981873386657469 +1.5451000000000001 0.7038969544082809 0.7038952331280883 1.8499567123672622e-07 -0.09818788432913196 +1.5452000000000001 0.7038979255028073 0.7038961994652877 1.8011569557010998e-07 -0.0981884298297581 +1.5453000000000001 0.7038988962542646 0.7038971655649962 1.7518614134695576e-07 -0.09818897516767292 +1.5454 0.7038998666622225 0.703898131427816 1.7020815010898582e-07 -0.09818952034292414 +1.5455 0.7039008367262624 0.7038990970543368 1.6518287415320798e-07 -0.0981900653555593 +1.5456 0.7039018064459784 0.7039000624451363 1.601114762578293e-07 -0.09819061020562603 +1.5457 0.7039027758209775 0.7039010276007789 1.5499512943245586e-07 -0.09819115489317194 +1.5458000000000003 0.7039037448508783 0.703901992521817 1.4983501661625098e-07 -0.09819169941824457 +1.5459 0.7039047135353133 0.7039029572087898 1.446323304107877e-07 -0.09819224378089152 +1.546 0.7039056818739269 0.703903921662224 1.3938827282677924e-07 -0.09819278798116028 +1.5461 0.703906649866377 0.7039048858826328 1.3410405500305367e-07 -0.09819333201909843 +1.5462 0.7039076175123345 0.7039058498705166 1.287808968838955e-07 -0.0981938758947535 +1.5463000000000002 0.7039085848114832 0.7039068136263626 1.234200269865926e-07 -0.09819441960817295 +1.5464 0.7039095517635204 0.703907777150645 1.1802268211694167e-07 -0.09819496315940435 +1.5465 0.7039105183681564 0.7039087404438241 1.125901070569979e-07 -0.09819550654849513 +1.5466000000000002 0.7039114846251151 0.7039097035063472 1.071235542805804e-07 -0.0981960497754928 +1.5467 0.7039124505341336 0.7039106663386477 1.0162428369306364e-07 -0.09819659284044474 +1.5468000000000002 0.7039134160949627 0.7039116289411461 9.609356230178001e-08 -0.09819713574339846 +1.5469000000000002 0.7039143813073672 0.7039125913142485 9.053266396621962e-08 -0.09819767848440139 +1.547 0.7039153461711245 0.7039135534583476 8.494286906149395e-08 -0.09819822106350089 +1.5471000000000001 0.7039163106860271 0.7039145153738227 7.932546422333153e-08 -0.09819876348074445 +1.5472000000000001 0.7039172748518805 0.7039154770610383 7.368174202194988e-08 -0.09819930573617942 +1.5473000000000001 0.7039182386685039 0.7039164385203455 6.801300069143867e-08 -0.0981998478298531 +1.5474 0.703919202135731 0.7039173997520818 6.232054380016228e-08 -0.09820038976181296 +1.5475 0.7039201652534093 0.7039183607565702 5.660567998361232e-08 -0.09820093153210631 +1.5476 0.7039211280213999 0.7039193215341197 5.086972261134082e-08 -0.09820147314078048 +1.5477 0.7039220904395787 0.7039202820850253 4.5113989511139096e-08 -0.09820201458788283 +1.5478000000000003 0.7039230525078348 0.7039212424095675 3.933980265852233e-08 -0.09820255587346058 +1.5479 0.7039240142260723 0.7039222025080132 3.3548487866214005e-08 -0.09820309699756108 +1.548 0.7039249755942094 0.7039231623806146 2.7741374489242965e-08 -0.09820363796023167 +1.5481 0.7039259366121782 0.7039241220276097 2.1919795112693152e-08 -0.09820417876151953 +1.5482 0.703926897279925 0.703925081449222 1.6085085255065912e-08 -0.09820471940147196 +1.5483000000000002 0.7039278575974106 0.7039260406456609 1.0238583049958228e-08 -0.09820525988013618 +1.5484 0.7039288175646102 0.7039269996171216 4.381628945955562e-09 -0.09820580019755941 +1.5485 0.7039297771815133 0.7039279583637845 -1.4844345934753034e-09 -0.09820634035378892 +1.5486000000000002 0.7039307364481234 0.703928916885816 -7.358263409175392e-09 -0.09820688034887184 +1.5487 0.7039316953644591 0.7039298751833678 -1.3238511954206944e-08 -0.09820742018285546 +1.5488000000000002 0.7039326539305524 0.7039308332565772 -1.9123833594827944e-08 -0.09820795985578684 +1.5489000000000002 0.7039336121464506 0.7039317911055675 -2.5012880918839214e-08 -0.09820849936771324 +1.549 0.7039345700122148 0.7039327487304468 -3.0904306051954614e-08 -0.09820903871868175 +1.5491000000000001 0.7039355275279211 0.7039337061313093 -3.679676095595663e-08 -0.09820957790873958 +1.5492000000000001 0.703936484693659 0.7039346633082345 -4.2688897746476044e-08 -0.09821011693793374 +1.5493000000000001 0.7039374415095332 0.7039356202612878 -4.8579368996189056e-08 -0.09821065580631143 +1.5494 0.7039383979756627 0.7039365769905197 -5.44668280421344e-08 -0.09821119451391971 +1.5495 0.7039393540921807 0.7039375334959665 -6.034992929481939e-08 -0.09821173306080566 +1.5496 0.7039403098592343 0.7039384897776504 -6.622732854786803e-08 -0.09821227144701636 +1.5497 0.7039412652769861 0.703939445835579 -7.209768328316976e-08 -0.0982128096725989 +1.5498000000000003 0.703942220345612 0.703940401669745 -7.795965297277552e-08 -0.09821334773760027 +1.5499 0.7039431750653025 0.7039413572801277 -8.381189939375006e-08 -0.09821388564206752 +1.55 0.7039441294362623 0.7039423126666917 -8.965308692827911e-08 -0.09821442338604769 +1.5501 0.7039450834587104 0.7039432678293869 -9.548188287071546e-08 -0.09821496096958776 +1.5502 0.7039460371328803 0.7039442227681496 -1.0129695772811975e-07 -0.09821549839273473 +1.5503000000000002 0.7039469904590191 0.7039451774829015 -1.0709698552904129e-07 -0.0982160356555356 +1.5504 0.703947943437388 0.7039461319735505 -1.1288064411495158e-07 -0.0982165727580373 +1.5505 0.7039488960682625 0.7039470862399901 -1.1864661545769872e-07 -0.09821710970028674 +1.5506000000000002 0.7039498483519323 0.7039480402820997 -1.2439358594920624e-07 -0.09821764648233093 +1.5507 0.7039508002887007 0.7039489940997445 -1.3012024669724342e-07 -0.09821818310421672 +1.5508000000000002 0.7039517518788856 0.7039499476927766 -1.3582529383160402e-07 -0.09821871956599111 +1.5509000000000002 0.7039527031228178 0.7039509010610334 -1.4150742880247869e-07 -0.09821925586770097 +1.551 0.7039536540208424 0.7039518542043384 -1.4716535866494962e-07 -0.09821979200939313 +1.5511000000000001 0.7039546045733185 0.7039528071225019 -1.5279779637909774e-07 -0.09822032799111455 +1.5512000000000001 0.7039555547806182 0.7039537598153199 -1.5840346111010983e-07 -0.09822086381291201 +1.5513000000000001 0.7039565046431278 0.7039547122825752 -1.6398107851450794e-07 -0.09822139947483238 +1.5514000000000001 0.7039574541612466 0.7039556645240368 -1.6952938101597037e-07 -0.0982219349769225 +1.5515 0.7039584033353881 0.7039566165394604 -1.7504710810023472e-07 -0.09822247031922925 +1.5516 0.7039593521659782 0.7039575683285879 -1.805330066377564e-07 -0.09822300550179934 +1.5517 0.7039603006534567 0.7039585198911484 -1.8598583111789635e-07 -0.0982235405246796 +1.5518000000000003 0.7039612487982769 0.7039594712268572 -1.9140434393341565e-07 -0.09822407538791683 +1.5519 0.7039621966009046 0.7039604223354168 -1.9678731569966468e-07 -0.0982246100915578 +1.552 0.7039631440618184 0.7039613732165162 -2.0213352551132213e-07 -0.09822514463564919 +1.5521 0.7039640911815108 0.7039623238698322 -2.0744176122342028e-07 -0.09822567902023782 +1.5522 0.7039650379604862 0.7039632742950279 -2.1271081970808403e-07 -0.09822621324537037 +1.5523000000000002 0.7039659843992623 0.7039642244917541 -2.1793950714943389e-07 -0.09822674731109354 +1.5524 0.7039669304983691 0.7039651744596489 -2.2312663932114174e-07 -0.09822728121745408 +1.5525 0.7039678762583494 0.7039661241983375 -2.2827104180847546e-07 -0.09822781496449862 +1.5526000000000002 0.7039688216797582 0.7039670737074333 -2.333715503413658e-07 -0.09822834855227391 +1.5527 0.703969766763163 0.7039680229865365 -2.3842701098869545e-07 -0.09822888198082655 +1.5528000000000002 0.7039707115091433 0.7039689720352356 -2.4343628047401866e-07 -0.09822941525020319 +1.5529000000000002 0.7039716559182907 0.7039699208531067 -2.483982264045448e-07 -0.09822994836045049 +1.553 0.703972599991209 0.7039708694397144 -2.5331172755910236e-07 -0.0982304813116151 +1.5531000000000001 0.7039735437285137 0.7039718177946108 -2.5817567406161146e-07 -0.09823101410374357 +1.5532000000000001 0.7039744871308315 0.7039727659173365 -2.6298896776272285e-07 -0.0982315467368825 +1.5533000000000001 0.7039754301988017 0.7039737138074205 -2.677505223439014e-07 -0.09823207921107852 +1.5534000000000001 0.703976372933074 0.7039746614643805 -2.724592636782486e-07 -0.09823261152637816 +1.5535 0.7039773153343102 0.7039756088877225 -2.7711412999356644e-07 -0.098233143682828 +1.5536 0.7039782574031827 0.7039765560769412 -2.817140721707301e-07 -0.09823367568047453 +1.5537 0.7039791991403754 0.7039775030315205 -2.8625805393797665e-07 -0.09823420751936432 +1.5538000000000003 0.7039801405465829 0.7039784497509335 -2.907450521311139e-07 -0.0982347391995439 +1.5539 0.7039810816225104 0.7039793962346421 -2.9517405689474807e-07 -0.09823527072105975 +1.554 0.7039820223688742 0.7039803424820977 -2.9954407194943133e-07 -0.09823580208395842 +1.5541 0.7039829627864005 0.7039812884927412 -3.038541147790119e-07 -0.09823633328828629 +1.5542 0.7039839028758261 0.7039822342660028 -3.0810321686308706e-07 -0.09823686433408986 +1.5543000000000002 0.7039848426378983 0.7039831798013032 -3.1229042390251704e-07 -0.09823739522141561 +1.5544 0.7039857820733735 0.7039841250980524 -3.164147960310615e-07 -0.09823792595030999 +1.5545 0.7039867211830186 0.7039850701556507 -3.2047540802354613e-07 -0.09823845652081929 +1.5546000000000002 0.7039876599676105 0.7039860149734889 -3.244713494970908e-07 -0.09823898693299012 +1.5547 0.7039885984279348 0.7039869595509478 -3.284017251400928e-07 -0.09823951718686874 +1.5548000000000002 0.7039895365647871 0.7039879038873992 -3.322656548787606e-07 -0.09824004728250159 +1.5549000000000002 0.7039904743789721 0.7039888479822052 -3.3606227408528033e-07 -0.09824057721993501 +1.555 0.7039914118713031 0.7039897918347191 -3.397907337651662e-07 -0.0982411069992154 +1.5551000000000001 0.7039923490426027 0.7039907354442856 -3.4345020080706057e-07 -0.09824163662038907 +1.5552000000000001 0.7039932858937024 0.7039916788102398 -3.4703985807293947e-07 -0.09824216608350236 +1.5553000000000001 0.7039942224254414 0.703992621931909 -3.5055890466872963e-07 -0.09824269538860161 +1.5554000000000001 0.7039951586386684 0.7039935648086117 -3.5400655601369735e-07 -0.0982432245357331 +1.5555 0.7039960945342391 0.7039945074396585 -3.5738204411800423e-07 -0.09824375352494316 +1.5556 0.703997030113018 0.7039954498243519 -3.6068461774230176e-07 -0.09824428235627805 +1.5557 0.703997965375877 0.7039963919619863 -3.639135425226314e-07 -0.09824481102978405 +1.5558 0.7039989003236958 0.7039973338518483 -3.6706810115777477e-07 -0.09824533954550742 +1.5559 0.7039998349573615 0.7039982754932174 -3.701475935272147e-07 -0.09824586790349435 +1.556 0.7040007692777683 0.7039992168853656 -3.731513369478745e-07 -0.0982463961037911 +1.5561 0.704001703285818 0.7040001580275581 -3.7607866618799557e-07 -0.09824692414644388 +1.5562 0.7040026369824186 0.7040010989190526 -3.789289337446933e-07 -0.09824745203149894 +1.5563000000000002 0.7040035703684853 0.7040020395591007 -3.8170150988559026e-07 -0.09824797975900243 +1.5564 0.7040045034449394 0.7040029799469467 -3.843957828361666e-07 -0.09824850732900049 +1.5565 0.7040054362127086 0.7040039200818293 -3.8701115894629323e-07 -0.09824903474153932 +1.5566000000000002 0.7040063686727269 0.7040048599629808 -3.8954706275268203e-07 -0.09824956199666507 +1.5567 0.7040073008259342 0.7040057995896274 -3.9200293711072476e-07 -0.0982500890944239 +1.5568000000000002 0.7040082326732762 0.7040067389609894 -3.943782434026599e-07 -0.0982506160348619 +1.5569000000000002 0.7040091642157036 0.7040076780762818 -3.9667246153063385e-07 -0.09825114281802522 +1.557 0.7040100954541728 0.7040086169347144 -3.9888509015956197e-07 -0.09825166944395992 +1.5571000000000002 0.7040110263896454 0.7040095555354915 -4.0101564670325107e-07 -0.09825219591271211 +1.5572000000000001 0.7040119570230878 0.7040104938778127 -4.0306366752562717e-07 -0.09825272222432785 +1.5573000000000001 0.704012887355471 0.7040114319608725 -4.050287079962467e-07 -0.09825324837885324 +1.5574000000000001 0.7040138173877705 0.7040123697838611 -4.069103425666243e-07 -0.09825377437633426 +1.5575 0.7040147471209661 0.7040133073459642 -4.0870816491594963e-07 -0.09825430021681694 +1.5576 0.7040156765560419 0.7040142446463638 -4.1042178801353746e-07 -0.09825482590034733 +1.5577 0.7040166056939858 0.7040151816842375 -4.1205084420903315e-07 -0.09825535142697145 +1.5578 0.7040175345357892 0.7040161184587591 -4.1359498528098504e-07 -0.09825587679673525 +1.5579 0.7040184630824471 0.7040170549690994 -4.150538825478667e-07 -0.09825640200968477 +1.558 0.7040193913349581 0.7040179912144255 -4.1642722688889355e-07 -0.09825692706586595 +1.5581 0.7040203192943233 0.7040189271939017 -4.1771472887586203e-07 -0.09825745196532482 +1.5582 0.7040212469615468 0.7040198629066889 -4.1891611880090496e-07 -0.0982579767081072 +1.5583000000000002 0.7040221743376353 0.7040207983519458 -4.200311467320028e-07 -0.09825850129425907 +1.5584 0.7040231014235978 0.7040217335288285 -4.2105958255461706e-07 -0.09825902572382635 +1.5585 0.704024028220446 0.704022668436491 -4.220012160202624e-07 -0.09825954999685495 +1.5586000000000002 0.7040249547291931 0.704023603074085 -4.228558567812013e-07 -0.09826007411339077 +1.5587 0.7040258809508542 0.7040245374407603 -4.2362333451534395e-07 -0.09826059807347963 +1.5588000000000002 0.7040268068864461 0.7040254715356655 -4.243034988360428e-07 -0.09826112187716747 +1.5589000000000002 0.7040277325369868 0.7040264053579477 -4.2489621938923694e-07 -0.09826164552450009 +1.559 0.7040286579034953 0.7040273389067524 -4.2540138583957443e-07 -0.09826216901552336 +1.5591000000000002 0.7040295829869918 0.7040282721812248 -4.2581890794674004e-07 -0.09826269235028307 +1.5592000000000001 0.7040305077884972 0.7040292051805086 -4.2614871550994415e-07 -0.09826321552882505 +1.5593000000000001 0.7040314323090329 0.7040301379037478 -4.2639075844425056e-07 -0.09826373855119515 +1.5594000000000001 0.7040323565496198 0.7040310703500854 -4.2654500673200424e-07 -0.09826426141743909 +1.5595 0.70403328051128 0.7040320025186647 -4.266114504783425e-07 -0.09826478412760266 +1.5596 0.7040342041950348 0.704032934408629 -4.2659009984874485e-07 -0.09826530668173167 +1.5597 0.7040351276019052 0.7040338660191218 -4.2648098512454435e-07 -0.09826582907987179 +1.5598 0.7040360507329118 0.7040347973492873 -4.262841566127218e-07 -0.09826635132206885 +1.5599 0.7040369735890741 0.7040357283982702 -4.2599968468060023e-07 -0.09826687340836845 +1.56 0.7040378961714109 0.7040366591652165 -4.2562765976972283e-07 -0.09826739533881639 +1.5601 0.7040388184809396 0.7040375896492732 -4.251681922778916e-07 -0.09826791711345836 +1.5602 0.7040397405186762 0.7040385198495889 -4.246214125938619e-07 -0.09826843873234004 +1.5603000000000002 0.7040406622856349 0.7040394497653135 -4.239874710695868e-07 -0.09826896019550709 +1.5604 0.7040415837828282 0.7040403793955989 -4.232665378883782e-07 -0.09826948150300517 +1.5605 0.7040425050112664 0.7040413087395989 -4.2245880313429574e-07 -0.09827000265487991 +1.5606000000000002 0.7040434259719575 0.70404223779647 -4.2156447671581887e-07 -0.09827052365117697 +1.5607 0.7040443466659072 0.7040431665653706 -4.205837882270691e-07 -0.09827104449194195 +1.5608000000000002 0.7040452670941183 0.7040440950454618 -4.195169869894433e-07 -0.09827156517722045 +1.5609000000000002 0.7040461872575907 0.704045023235908 -4.1836434193365246e-07 -0.09827208570705806 +1.561 0.7040471071573216 0.7040459511358764 -4.1712614160666073e-07 -0.09827260608150043 +1.5611000000000002 0.7040480267943037 0.7040468787445376 -4.158026940051518e-07 -0.09827312630059305 +1.5612000000000001 0.7040489461695274 0.7040478060610655 -4.1439432652001784e-07 -0.0982736463643815 +1.5613000000000001 0.7040498652839785 0.7040487330846379 -4.1290138590166503e-07 -0.0982741662729113 +1.5614000000000001 0.7040507841386395 0.7040496598144366 -4.11324238162869e-07 -0.09827468602622805 +1.5615 0.7040517027344881 0.7040505862496476 -4.096632684677526e-07 -0.0982752056243772 +1.5616 0.704052621072498 0.7040515123894604 -4.0791888100688567e-07 -0.09827572506740423 +1.5617 0.7040535391536387 0.7040524382330702 -4.0609149899728525e-07 -0.09827624435535473 +1.5618 0.7040544569788736 0.7040533637796761 -4.0418156448118747e-07 -0.09827676348827408 +1.5619 0.7040553745491624 0.7040542890284827 -4.0218953831910875e-07 -0.09827728246620779 +1.562 0.7040562918654596 0.7040552139786991 -4.0011589996780117e-07 -0.09827780128920131 +1.5621 0.7040572089287135 0.7040561386295405 -3.9796114737616906e-07 -0.09827831995730012 +1.5622 0.7040581257398674 0.7040570629802269 -3.957257969991468e-07 -0.09827883847054958 +1.5623000000000002 0.7040590422998585 0.7040579870299843 -3.934103835478986e-07 -0.09827935682899511 +1.5624 0.7040599586096187 0.7040589107780448 -3.9101545987879627e-07 -0.09827987503268217 +1.5625 0.7040608746700728 0.7040598342236463 -3.8854159688933576e-07 -0.09828039308165608 +1.5626000000000002 0.70406179048214 0.7040607573660334 -3.8598938341405375e-07 -0.09828091097596225 +1.5627 0.7040627060467328 0.7040616802044564 -3.833594259955442e-07 -0.09828142871564603 +1.5628000000000002 0.7040636213647565 0.7040626027381731 -3.8065234880813037e-07 -0.09828194630075276 +1.5629000000000002 0.7040645364371103 0.704063524966448 -3.7786879346357605e-07 -0.09828246373132782 +1.563 0.7040654512646859 0.7040644468885526 -3.7500941894169637e-07 -0.09828298100741656 +1.5631000000000002 0.7040663658483672 0.704065368503765 -3.7207490134055776e-07 -0.09828349812906413 +1.5632000000000001 0.7040672801890315 0.7040662898113721 -3.690659337585167e-07 -0.09828401509631604 +1.5633000000000001 0.704068194287548 0.7040672108106667 -3.659832261415641e-07 -0.0982845319092174 +1.5634000000000001 0.7040691081447783 0.7040681315009507 -3.6282750510291395e-07 -0.09828504856781362 +1.5635 0.7040700217615758 0.7040690518815336 -3.5959951373565335e-07 -0.09828556507214986 +1.5636 0.7040709351387858 0.7040699719517325 -3.563000114878423e-07 -0.09828608142227144 +1.5637 0.7040718482772452 0.7040708917108733 -3.529297739196524e-07 -0.0982865976182235 +1.5638 0.7040727611777827 0.7040718111582904 -3.494895925645891e-07 -0.09828711366005138 +1.5639 0.7040736738412179 0.7040727302933265 -3.4598027470744697e-07 -0.09828762954780018 +1.564 0.7040745862683618 0.7040736491153337 -3.424026432524707e-07 -0.09828814528151522 +1.5641 0.7040754984600162 0.704074567623672 -3.387575364943718e-07 -0.09828866086124155 +1.5642 0.7040764104169741 0.7040754858177117 -3.3504580793097816e-07 -0.09828917628702444 +1.5643000000000002 0.7040773221400187 0.7040764036968316 -3.312683260411897e-07 -0.09828969155890899 +1.5644 0.7040782336299242 0.7040773212604203 -3.274259740698726e-07 -0.09829020667694037 +1.5645 0.7040791448874546 0.7040782385078759 -3.235196499237758e-07 -0.09829072164116372 +1.5646000000000002 0.7040800559133644 0.7040791554386062 -3.1955026583846413e-07 -0.09829123645162413 +1.5647 0.7040809667083981 0.704080072052029 -3.155187482326016e-07 -0.0982917511083667 +1.5648000000000002 0.7040818772732902 0.704080988347572 -3.114260374650901e-07 -0.09829226561143652 +1.5649000000000002 0.7040827876087651 0.7040819043246737 -3.0727308760608585e-07 -0.09829277996087876 +1.565 0.7040836977155364 0.704082819982782 -3.0306086631903817e-07 -0.09829329415673843 +1.5651000000000002 0.7040846075943072 0.7040837353213559 -2.9879035446517266e-07 -0.09829380819906056 +1.5652000000000001 0.7040855172457703 0.704084650339865 -2.944625459924688e-07 -0.09829432208789024 +1.5653000000000001 0.7040864266706071 0.7040855650377893 -2.900784476650431e-07 -0.09829483582327242 +1.5654000000000001 0.704087335869489 0.7040864794146202 -2.8563907885845174e-07 -0.09829534940525222 +1.5655 0.7040882448430754 0.7040873934698596 -2.811454712578487e-07 -0.09829586283387459 +1.5656 0.7040891535920151 0.7040883072030211 -2.76598668712269e-07 -0.09829637610918457 +1.5657 0.7040900621169449 0.7040892206136291 -2.719997269154395e-07 -0.09829688923122705 +1.5658 0.7040909704184908 0.7040901337012199 -2.6734971320455103e-07 -0.09829740220004707 +1.5659 0.704091878497267 0.7040910464653408 -2.6264970628964157e-07 -0.09829791501568956 +1.566 0.7040927863538757 0.7040919589055512 -2.5790079600032656e-07 -0.09829842767819948 +1.5661 0.704093693988908 0.7040928710214218 -2.531040830464071e-07 -0.0982989401876217 +1.5662 0.7040946014029423 0.704093782812536 -2.482606787854169e-07 -0.09829945254400124 +1.5663000000000002 0.7040955085965455 0.704094694278488 -2.433717048964945e-07 -0.0982999647473829 +1.5664 0.704096415570272 0.7040956054188852 -2.384382931999718e-07 -0.09830047679781162 +1.5665 0.7040973223246644 0.7040965162333466 -2.3346158532430716e-07 -0.0983009886953323 +1.5666000000000002 0.7040982288602524 0.7040974267215034 -2.2844273251873548e-07 -0.09830150043998978 +1.5667 0.7040991351775536 0.7040983368829996 -2.2338289532713995e-07 -0.09830201203182887 +1.5668000000000002 0.704100041277073 0.7040992467174919 -2.182832433243742e-07 -0.09830252347089448 +1.5669000000000002 0.7041009471593027 0.7041001562246488 -2.131449548803399e-07 -0.09830303475723136 +1.567 0.7041018528247226 0.7041010654041521 -2.079692168546754e-07 -0.09830354589088439 +1.5671000000000002 0.7041027582737994 0.7041019742556964 -2.0275722435042498e-07 -0.0983040568718984 +1.5672000000000001 0.7041036635069868 0.7041028827789885 -1.9751018039831925e-07 -0.09830456770031806 +1.5673000000000001 0.7041045685247258 0.704103790973749 -1.9222929572779157e-07 -0.09830507837618824 +1.5674000000000001 0.7041054733274443 0.704104698839711 -1.869157884616668e-07 -0.09830558889955375 +1.5675 0.704106377915557 0.7041056063766209 -1.8157088383166653e-07 -0.0983060992704592 +1.5676 0.704107282289465 0.704106513584238 -1.7619581390085348e-07 -0.09830660948894943 +1.5677 0.7041081864495569 0.7041074204623354 -1.7079181728607562e-07 -0.09830711955506918 +1.5678 0.7041090903962073 0.7041083270106987 -1.6536013886653267e-07 -0.09830762946886311 +1.5679 0.7041099941297777 0.7041092332291273 -1.5990202949754673e-07 -0.0983081392303759 +1.568 0.7041108976506162 0.7041101391174343 -1.544187457312718e-07 -0.09830864883965229 +1.5681 0.704111800959057 0.7041110446754456 -1.4891154949923935e-07 -0.09830915829673695 +1.5682 0.7041127040554209 0.7041119499030013 -1.433817078677624e-07 -0.09830966760167449 +1.5683000000000002 0.7041136069400153 0.7041128547999548 -1.3783049270833791e-07 -0.09831017675450962 +1.5684 0.7041145096131336 0.704113759366173 -1.322591804183565e-07 -0.09831068575528695 +1.5685 0.7041154120750559 0.7041146636015372 -1.2666905162966868e-07 -0.09831119460405115 +1.5686000000000002 0.7041163143260478 0.7041155675059411 -1.2106139091888624e-07 -0.09831170330084679 +1.5687 0.7041172163663616 0.7041164710792933 -1.1543748649513186e-07 -0.09831221184571845 +1.5688000000000002 0.7041181181962355 0.7041173743215159 -1.0979862991727929e-07 -0.09831272023871074 +1.5689000000000002 0.7041190198158944 0.7041182772325447 -1.0414611580512184e-07 -0.09831322847986829 +1.569 0.7041199212255487 0.7041191798123294 -9.8481241521918e-08 -0.09831373656923556 +1.5691000000000002 0.704120822425395 0.7041200820608334 -9.28053068898968e-08 -0.09831424450685712 +1.5692000000000002 0.7041217234156159 0.7041209839780345 -8.71196138901506e-08 -0.09831475229277757 +1.5693000000000001 0.7041226241963803 0.704121885563924 -8.142546636339537e-08 -0.09831525992704135 +1.5694000000000001 0.7041235247678428 0.7041227868185072 -7.572416971246554e-08 -0.09831576740969306 +1.5695 0.7041244251301446 0.7041236877418036 -7.001703060047215e-08 -0.09831627474077717 +1.5696 0.7041253252834117 0.7041245883338465 -6.43053566506957e-08 -0.09831678192033816 +1.5697 0.7041262252277571 0.7041254885946832 -5.8590456151683123e-08 -0.09831728894842046 +1.5698 0.7041271249632796 0.7041263885243749 -5.287363775518909e-08 -0.09831779582506861 +1.5699 0.7041280244900638 0.7041272881229969 -4.715621017541832e-08 -0.09831830255032703 +1.57 0.70412892380818 0.7041281873906383 -4.1439481891195236e-08 -0.09831880912424011 +1.5701 0.7041298229176851 0.7041290863274022 -3.572476084488102e-08 -0.09831931554685226 +1.5702 0.7041307218186216 0.704129984933406 -3.0013354145952756e-08 -0.09831982181820793 +1.5703000000000003 0.7041316205110184 0.7041308832087804 -2.4306567769595208e-08 -0.09832032793835158 +1.5704 0.7041325189948897 0.704131781153671 -1.8605706259087335e-08 -0.09832083390732754 +1.5705 0.7041334172702366 0.7041326787682363 -1.291207242992351e-08 -0.09832133972518017 +1.5706000000000002 0.7041343153370458 0.7041335760526493 -7.22696706645376e-09 -0.09832184539195388 +1.5707 0.7041352131952898 0.7041344730070966 -1.551688631751258e-09 -0.09832235090769299 +1.5708000000000002 0.7041361108449276 0.7041353696317788 4.112467033579037e-09 -0.09832285627244179 +1.5709000000000002 0.7041370082859044 0.7041362659269101 9.764207008038095e-09 -0.09832336148624464 +1.571 0.7041379055181517 0.7041371618927187 1.5402241577630593e-08 -0.09832386654914588 +1.5711000000000002 0.7041388025415868 0.7041380575294465 2.1025284540308886e-08 -0.09832437146118979 +1.5712000000000002 0.7041396993561134 0.704138952837349 2.6632053489600294e-08 -0.09832487622242064 +1.5713000000000001 0.7041405959616216 0.7041398478166951 3.22212701138469e-08 -0.0983253808328827 +1.5714000000000001 0.7041414923579877 0.7041407424677677 3.7791660479832845e-08 -0.09832588529262021 +1.5715 0.7041423885450748 0.7041416367908633 4.334195533202412e-08 -0.09832638960167746 +1.5716 0.704143284522732 0.7041425307862914 4.8870890372726405e-08 -0.09832689376009864 +1.5717 0.7041441802907953 0.7041434244543756 5.437720656739642e-08 -0.09832739776792804 +1.5718 0.7041450758490868 0.7041443177954523 5.98596504031157e-08 -0.09832790162520981 +1.5719 0.7041459711974156 0.7041452108098716 6.531697419737137e-08 -0.09832840533198814 +1.572 0.7041468663355778 0.7041461034979966 7.074793637734667e-08 -0.09832890888830731 +1.5721 0.7041477612633553 0.7041469958602038 7.615130174880302e-08 -0.09832941229421144 +1.5722 0.7041486559805179 0.7041478878968827 8.152584180312616e-08 -0.09832991554974466 +1.5723000000000003 0.7041495504868216 0.7041487796084358 8.687033495845264e-08 -0.09833041865495115 +1.5724 0.7041504447820096 0.7041496709952786 9.218356687018536e-08 -0.09833092160987504 +1.5725 0.7041513388658123 0.7041505620578394 9.746433071028404e-08 -0.09833142441456043 +1.5726000000000002 0.7041522327379472 0.7041514527965593 1.0271142740145289e-07 -0.09833192706905143 +1.5727 0.7041531263981189 0.7041523432118924 1.0792366593459501e-07 -0.09833242957339214 +1.5728000000000002 0.7041540198460197 0.7041532333043048 1.1309986360993896e-07 -0.09833293192762665 +1.5729000000000002 0.7041549130813287 0.7041541230742758 1.182388463319417e-07 -0.09833343413179904 +1.573 0.7041558061037132 0.7041550125222971 1.233394488243944e-07 -0.09833393618595337 +1.5731000000000002 0.7041566989128281 0.7041559016488721 1.284005149600198e-07 -0.09833443809013372 +1.5732000000000002 0.7041575915083151 0.704156790454517 1.3342089797210854e-07 -0.09833493984438407 +1.5733000000000001 0.7041584838898047 0.7041576789397597 1.3839946075289156e-07 -0.09833544144874842 +1.5734000000000001 0.704159376056915 0.7041585671051409 1.4333507606170692e-07 -0.09833594290327091 +1.5735 0.704160268009252 0.7041594549512122 1.4822662684765842e-07 -0.09833644420799537 +1.5736 0.7041611597464104 0.7041603424785378 1.5307300642308785e-07 -0.0983369453629659 +1.5737 0.7041620512679724 0.7041612296876931 1.5787311878623367e-07 -0.09833744636822647 +1.5738 0.704162942573509 0.7041621165792653 1.6262587883286717e-07 -0.098337947223821 +1.5739 0.7041638336625796 0.704163003153853 1.6733021259915382e-07 -0.0983384479297934 +1.574 0.7041647245347323 0.7041638894120662 1.7198505751145343e-07 -0.09833894848618768 +1.5741 0.7041656151895042 0.7041647753545259 1.765893626326509e-07 -0.09833944889304774 +1.5742 0.7041665056264206 0.7041656609818643 1.8114208888767025e-07 -0.09833994915041748 +1.5743000000000003 0.7041673958449964 0.7041665462947249 1.8564220932368314e-07 -0.09834044925834083 +1.5744 0.7041682858447356 0.7041674312937614 1.9008870928705068e-07 -0.09834094921686165 +1.5745 0.7041691756251311 0.7041683159796386 1.9448058670434865e-07 -0.09834144902602387 +1.5746000000000002 0.7041700651856653 0.7041692003530315 1.988168523009426e-07 -0.09834194868587122 +1.5747 0.7041709545258106 0.704170084414626 2.0309652980221582e-07 -0.09834244819644766 +1.5748000000000002 0.7041718436450286 0.7041709681651178 2.073186561590834e-07 -0.09834294755779703 +1.5749000000000002 0.7041727325427709 0.7041718516052131 2.114822817700368e-07 -0.09834344676996311 +1.575 0.704173621218479 0.7041727347356275 2.1558647071706627e-07 -0.09834394583298971 +1.5751000000000002 0.7041745096715848 0.704173617557087 2.1963030093913316e-07 -0.09834444474692061 +1.5752000000000002 0.7041753979015101 0.704174500070327 2.236128644333979e-07 -0.09834494351179965 +1.5753000000000001 0.7041762859076673 0.7041753822760926 2.2753326751195901e-07 -0.09834544212767055 +1.5754000000000001 0.7041771736894596 0.704176264175138 2.3139063094063106e-07 -0.09834594059457712 +1.5755 0.7041780612462806 0.7041771457682267 2.3518409017486697e-07 -0.098346438912563 +1.5756000000000001 0.704178948577515 0.7041780270561313 2.389127955679249e-07 -0.09834693708167203 +1.5757 0.7041798356825386 0.7041789080396335 2.4257591249576826e-07 -0.09834743510194793 +1.5758 0.7041807225607185 0.7041797887195236 2.461726216276827e-07 -0.09834793297343443 +1.5759 0.7041816092114128 0.7041806690966002 2.4970211902342054e-07 -0.0983484306961752 +1.576 0.7041824956339717 0.7041815491716705 2.531636163830009e-07 -0.09834892827021391 +1.5761 0.704183381827737 0.7041824289455498 2.5655634118548765e-07 -0.09834942569559425 +1.5762 0.7041842677920418 0.7041833084190616 2.598795368763396e-07 -0.09834992297235992 +1.5763000000000003 0.704185153526212 0.7041841875930375 2.6313246304088267e-07 -0.09835042010055454 +1.5764 0.7041860390295656 0.704185066468316 2.663143955222713e-07 -0.09835091708022171 +1.5765 0.7041869243014125 0.7041859450457437 2.6942462666434963e-07 -0.0983514139114051 +1.5766000000000002 0.7041878093410561 0.7041868233261748 2.7246246540185703e-07 -0.09835191059414827 +1.5767 0.7041886941477918 0.7041877013104703 2.7542723742696174e-07 -0.0983524071284949 +1.5768000000000002 0.7041895787209087 0.7041885789994979 2.7831828538354975e-07 -0.09835290351448854 +1.5769000000000002 0.7041904630596885 0.7041894563941329 2.8113496892273604e-07 -0.09835339975217278 +1.577 0.704191347163406 0.7041903334952566 2.838766649734814e-07 -0.09835389584159117 +1.5771000000000002 0.7041922310313303 0.7041912103037571 2.8654276773565357e-07 -0.09835439178278726 +1.5772 0.7041931146627235 0.704192086820528 2.8913268890901067e-07 -0.09835488757580457 +1.5773000000000001 0.7041939980568419 0.70419296304647 2.9164585781810137e-07 -0.09835538322068665 +1.5774000000000001 0.7041948812129362 0.7041938389824891 2.940817214955316e-07 -0.09835587871747697 +1.5775 0.7041957641302508 0.7041947146294969 2.964397448138034e-07 -0.09835637406621914 +1.5776000000000001 0.704196646808025 0.7041955899884111 2.987194106379709e-07 -0.09835686926695658 +1.5777 0.7041975292454922 0.7041964650601538 3.0092021989502893e-07 -0.09835736431973277 +1.5778 0.7041984114418812 0.7041973398456526 3.030416917335077e-07 -0.09835785922459112 +1.5779 0.7041992933964161 0.7041982143458403 3.0508336357204513e-07 -0.09835835398157515 +1.578 0.7042001751083153 0.7041990885616543 3.070447912520424e-07 -0.09835884859072833 +1.5781 0.7042010565767937 0.704199962494036 3.089255490792975e-07 -0.09835934305209407 +1.5782 0.7042019378010608 0.7042008361439316 3.107252299766605e-07 -0.0983598373657157 +1.5783000000000003 0.7042028187803226 0.7042017095122911 3.124434455048508e-07 -0.09836033153163667 +1.5784 0.7042036995137814 0.7042025826000688 3.140798260012345e-07 -0.09836082554990042 +1.5785 0.7042045800006351 0.7042034554082226 3.1563402064921364e-07 -0.09836131942055028 +1.5786000000000002 0.7042054602400786 0.7042043279377137 3.171056975129205e-07 -0.09836181314362971 +1.5787 0.7042063402313028 0.7042052001895065 3.1849454365517893e-07 -0.09836230671918193 +1.5788000000000002 0.7042072199734959 0.7042060721645688 3.198002651930154e-07 -0.09836280014725031 +1.5789000000000002 0.7042080994658432 0.7042069438638712 3.2102258736704803e-07 -0.09836329342787825 +1.579 0.7042089787075272 0.704207815288387 3.2216125457618094e-07 -0.098363786561109 +1.5791000000000002 0.7042098576977276 0.704208686439092 3.2321603039842106e-07 -0.09836427954698587 +1.5792 0.7042107364356225 0.7042095573169638 3.2418669771577813e-07 -0.09836477238555215 +1.5793000000000001 0.7042116149203872 0.704210427922983 3.250730587350814e-07 -0.09836526507685119 +1.5794000000000001 0.7042124931511953 0.7042112982581316 3.258749350018575e-07 -0.09836575762092623 +1.5795 0.7042133711272185 0.7042121683233926 3.265921674627803e-07 -0.09836625001782044 +1.5796000000000001 0.7042142488476275 0.7042130381197518 3.2722461644485445e-07 -0.09836674226757719 +1.5797 0.7042151263115916 0.7042139076481952 3.2777216175255974e-07 -0.09836723437023967 +1.5798 0.7042160035182785 0.70421477690971 3.2823470266091226e-07 -0.09836772632585108 +1.5799 0.7042168804668554 0.7042156459052843 3.286121579085255e-07 -0.09836821813445458 +1.58 0.7042177571564888 0.704216514635907 3.2890446578087706e-07 -0.09836870979609343 +1.5801 0.7042186335863453 0.7042173831025671 3.291115839992864e-07 -0.09836920131081084 +1.5802 0.7042195097555902 0.7042182513062542 3.292334898458149e-07 -0.09836969267864988 +1.5803000000000003 0.7042203856633895 0.7042191192479572 3.2927018010081577e-07 -0.09837018389965377 +1.5804 0.7042212613089094 0.7042199869286656 3.2922167107068967e-07 -0.09837067497386565 +1.5805 0.704222136691316 0.7042208543493681 3.290879984838013e-07 -0.09837116590132865 +1.5806000000000002 0.7042230118097763 0.7042217215110526 3.2886921763619625e-07 -0.0983716566820859 +1.5807 0.7042238866634583 0.7042225884147064 3.285654032805785e-07 -0.09837214731618052 +1.5808000000000002 0.7042247612515307 0.7042234550613156 3.281766495430438e-07 -0.0983726378036556 +1.5809000000000002 0.7042256355731634 0.7042243214518648 3.2770307002022436e-07 -0.09837312814455418 +1.581 0.7042265096275281 0.7042251875873378 3.271447976890829e-07 -0.09837361833891939 +1.5811000000000002 0.7042273834137976 0.704226053468716 3.265019848583406e-07 -0.09837410838679428 +1.5812 0.7042282569311468 0.7042269190969794 3.2577480317541596e-07 -0.09837459828822183 +1.5813000000000001 0.7042291301787529 0.704227784473106 3.2496344349458584e-07 -0.09837508804324514 +1.5814000000000001 0.7042300031557949 0.704228649598071 3.240681159394354e-07 -0.09837557765190727 +1.5815 0.7042308758614546 0.7042295144728472 3.230890497432637e-07 -0.09837606711425116 +1.5816000000000001 0.7042317482949163 0.704230379098405 3.2202649329071686e-07 -0.09837655643031983 +1.5817 0.704232620455367 0.7042312434757119 3.2088071395125484e-07 -0.09837704560015624 +1.5818 0.7042334923419973 0.7042321076057318 3.1965199808609013e-07 -0.09837753462380344 +1.5819 0.7042343639540007 0.7042329714894261 3.183406509996156e-07 -0.09837802350130437 +1.582 0.704235235290574 0.7042338351277516 3.169469967728711e-07 -0.09837851223270193 +1.5821 0.7042361063509179 0.7042346985216625 3.154713782704821e-07 -0.09837900081803912 +1.5822 0.7042369771342369 0.7042355616721083 3.139141569949433e-07 -0.09837948925735877 +1.5823000000000003 0.7042378476397398 0.7042364245800348 3.1227571301029045e-07 -0.0983799775507039 +1.5824 0.7042387178666395 0.7042372872463831 3.105564448935283e-07 -0.09838046569811737 +1.5825 0.7042395878141531 0.70423814967209 3.0875676958197484e-07 -0.09838095369964206 +1.5826000000000002 0.7042404574815027 0.7042390118580882 3.068771223385669e-07 -0.09838144155532087 +1.5827 0.7042413268679151 0.7042398738053044 3.049179565853266e-07 -0.09838192926519665 +1.5828000000000002 0.7042421959726224 0.7042407355146608 3.0287974379233917e-07 -0.0983824168293122 +1.5829000000000002 0.7042430647948617 0.7042415969870746 3.007629734083639e-07 -0.09838290424771051 +1.583 0.7042439333338752 0.7042424582234568 2.9856815272899517e-07 -0.09838339152043425 +1.5831000000000002 0.7042448015889118 0.7042433192247132 2.962958067509458e-07 -0.09838387864752635 +1.5832 0.7042456695592247 0.7042441799917436 2.9394647808878016e-07 -0.09838436562902951 +1.5833000000000002 0.7042465372440747 0.7042450405254421 2.915207268153197e-07 -0.09838485246498663 +1.5834000000000001 0.7042474046427272 0.7042459008266961 2.89019130329804e-07 -0.09838533915544038 +1.5835 0.7042482717544549 0.7042467608963869 2.864422832191127e-07 -0.09838582570043362 +1.5836000000000001 0.7042491385785372 0.7042476207353892 2.837907971398046e-07 -0.09838631210000906 +1.5837 0.7042500051142597 0.7042484803445704 2.8106530067933955e-07 -0.09838679835420945 +1.5838 0.7042508713609154 0.704249339724792 2.7826643912709503e-07 -0.09838728446307754 +1.5839 0.7042517373178034 0.7042501988769074 2.753948744396717e-07 -0.09838777042665603 +1.584 0.7042526029842315 0.7042510578017631 2.724512849841543e-07 -0.09838825624498765 +1.5841 0.7042534683595139 0.7042519165001979 2.6943636543402816e-07 -0.09838874191811502 +1.5842 0.7042543334429725 0.7042527749730436 2.66350826602646e-07 -0.09838922744608093 +1.5843000000000003 0.7042551982339371 0.7042536332211236 2.6319539525587743e-07 -0.09838971282892797 +1.5844 0.7042560627317461 0.7042544912452531 2.5997081395945365e-07 -0.09839019806669888 +1.5845 0.7042569269357448 0.7042553490462395 2.5667784087080037e-07 -0.09839068315943622 +1.5846000000000002 0.7042577908452878 0.7042562066248823 2.5331724957250445e-07 -0.0983911681071827 +1.5847 0.7042586544597375 0.7042570639819714 2.4988982895435274e-07 -0.09839165290998084 +1.5848000000000002 0.7042595177784653 0.7042579211182893 2.4639638294271515e-07 -0.09839213756787336 +1.5849000000000002 0.7042603808008507 0.704258778034609 2.428377303687057e-07 -0.09839262208090277 +1.585 0.7042612435262834 0.7042596347316945 2.3921470473226014e-07 -0.09839310644911173 +1.5851000000000002 0.7042621059541607 0.7042604912103007 2.3552815403560245e-07 -0.09839359067254275 +1.5852 0.7042629680838903 0.7042613474711736 2.3177894058895587e-07 -0.09839407475123846 +1.5853000000000002 0.7042638299148885 0.7042622035150499 2.2796794080931493e-07 -0.09839455868524136 +1.5854000000000001 0.7042646914465813 0.7042630593426558 2.2409604497064528e-07 -0.098395042474594 +1.5855 0.7042655526784047 0.7042639149547086 2.2016415705816694e-07 -0.09839552611933892 +1.5856000000000001 0.7042664136098041 0.7042647703519155 2.16173194525493e-07 -0.09839600961951857 +1.5857 0.7042672742402353 0.7042656255349736 2.1212408806911554e-07 -0.09839649297517553 +1.5858 0.7042681345691637 0.7042664805045703 2.0801778144452499e-07 -0.09839697618635225 +1.5859 0.7042689945960652 0.7042673352613822 2.0385523122681826e-07 -0.09839745925309124 +1.586 0.704269854320426 0.7042681898060756 1.9963740659906248e-07 -0.09839794217543492 +1.5861 0.7042707137417432 0.7042690441393067 1.953652891059643e-07 -0.09839842495342582 +1.5862 0.7042715728595236 0.7042698982617204 1.9103987243529463e-07 -0.0983989075871063 +1.5863000000000003 0.7042724316732856 0.7042707521739512 1.8666216219931364e-07 -0.09839939007651885 +1.5864 0.7042732901825581 0.7042716058766224 1.8223317570231767e-07 -0.0983998724217058 +1.5865 0.7042741483868811 0.7042724593703467 1.7775394168390024e-07 -0.09840035462270966 +1.5866000000000002 0.7042750062858059 0.7042733126557251 1.7322550008649906e-07 -0.09840083667957276 +1.5867 0.7042758638788942 0.7042741657333476 1.6864890181253478e-07 -0.09840131859233744 +1.5868000000000002 0.7042767211657205 0.7042750186037928 1.6402520850930524e-07 -0.09840180036104618 +1.5869000000000002 0.7042775781458697 0.7042758712676278 1.5935549227755197e-07 -0.09840228198574127 +1.587 0.7042784348189383 0.7042767237254083 1.5464083546676277e-07 -0.09840276346646509 +1.5871000000000002 0.7042792911845348 0.7042775759776778 1.4988233037679932e-07 -0.09840324480325996 +1.5872 0.7042801472422795 0.7042784280249681 1.45081079039322e-07 -0.09840372599616815 +1.5873000000000002 0.7042810029918043 0.7042792798677991 1.4023819297145912e-07 -0.09840420704523202 +1.5874000000000001 0.7042818584327537 0.7042801315066791 1.353547929086596e-07 -0.09840468795049387 +1.5875 0.7042827135647833 0.7042809829421035 1.3043200849244263e-07 -0.09840516871199595 +1.5876000000000001 0.7042835683875618 0.7042818341745565 1.2547097810039487e-07 -0.09840564932978059 +1.5877000000000001 0.7042844229007696 0.7042826852045088 1.204728485235118e-07 -0.09840612980388999 +1.5878 0.7042852771040996 0.7042835360324196 1.1543877470598929e-07 -0.09840661013436643 +1.5879 0.7042861309972572 0.7042843866587352 1.103699194954233e-07 -0.09840709032125214 +1.588 0.7042869845799603 0.7042852370838896 1.0526745337566257e-07 -0.09840757036458934 +1.5881 0.7042878378519393 0.704286087308304 1.0013255417537503e-07 -0.09840805026442025 +1.5882 0.7042886908129373 0.704286937332387 9.496640681824764e-08 -0.09840853002078709 +1.5883000000000003 0.7042895434627101 0.7042877871565343 8.977020304196115e-08 -0.09840900963373199 +1.5884 0.7042903958010266 0.7042886367811287 8.454514111369549e-08 -0.09840948910329718 +1.5885 0.7042912478276682 0.7042894862065405 7.929242557859484e-08 -0.09840996842952485 +1.5886000000000002 0.7042920995424291 0.7042903354331265 7.40132669388438e-08 -0.09841044761245706 +1.5887 0.7042929509451172 0.7042911844612303 6.870888142294918e-08 -0.09841092665213597 +1.5888000000000002 0.7042938020355531 0.7042920332911833 6.338049068216334e-08 -0.0984114055486038 +1.5889000000000002 0.7042946528135701 0.704292881923303 5.802932151639795e-08 -0.0984118843019026 +1.589 0.704295503279015 0.7042937303578937 5.26566055758515e-08 -0.09841236291207447 +1.5891000000000002 0.7042963534317483 0.7042945785952468 4.726357908865775e-08 -0.09841284137916154 +1.5892 0.704297203271643 0.7042954266356404 4.185148258506466e-08 -0.09841331970320587 +1.5893000000000002 0.7042980527985857 0.7042962744793387 3.642156060600088e-08 -0.09841379788424949 +1.5894000000000001 0.7042989020124764 0.7042971221265932 3.097506140990747e-08 -0.09841427592233454 +1.5895 0.7042997509132282 0.7042979695776415 2.551323668997796e-08 -0.09841475381750298 +1.5896000000000001 0.7043005995007678 0.704298816832708 2.0037341287929e-08 -0.09841523156979687 +1.5897000000000001 0.7043014477750357 0.7042996638920035 1.4548632907770975e-08 -0.09841570917925824 +1.5898 0.7043022957359854 0.7043005107557254 9.048371829578628e-09 -0.09841618664592916 +1.5899 0.7043031433835838 0.7043013574240578 3.537820605047093e-09 -0.09841666396985155 +1.59 0.7043039907178117 0.7043022038971704 -1.981756210522878e-09 -0.09841714115106744 +1.5901 0.7043048377386634 0.7043030501752201 -7.50909236787306e-09 -0.09841761818961875 +1.5902 0.7043056844461462 0.7043038962583498 -1.3042920200476149e-08 -0.09841809508554747 +1.5903000000000003 0.7043065308402816 0.7043047421466893 -1.858197092420924e-08 -0.09841857183889556 +1.5904 0.7043073769211046 0.7043055878403541 -2.4124974923583203e-08 -0.09841904844970495 +1.5905 0.7043082226886634 0.7043064333394469 -2.967066203948994e-08 -0.09841952491801757 +1.5906000000000002 0.70430906814302 0.704307278644056 -3.521776186735798e-08 -0.09842000124387533 +1.5907 0.7043099132842499 0.7043081237542564 -4.076500404533341e-08 -0.09842047742732012 +1.5908000000000002 0.7043107581124424 0.7043089686701098 -4.6311118543883854e-08 -0.09842095346839387 +1.5909 0.7043116026276998 0.7043098133916639 -5.18548359570558e-08 -0.09842142936713841 +1.591 0.7043124468301386 0.7043106579189526 -5.739488779339316e-08 -0.09842190512359564 +1.5911000000000002 0.7043132907198888 0.704311502251997 -6.293000676376587e-08 -0.09842238073780743 +1.5912 0.7043141342970931 0.7043123463908039 -6.845892707666584e-08 -0.09842285620981558 +1.5913000000000002 0.7043149775619086 0.7043131903353668 -7.398038472106183e-08 -0.09842333153966194 +1.5914000000000001 0.7043158205145055 0.7043140340856657 -7.949311776108553e-08 -0.0984238067273883 +1.5915 0.7043166631550675 0.7043148776416671 -8.499586662009256e-08 -0.09842428177303647 +1.5916000000000001 0.7043175054837918 0.7043157210033242 -9.048737436775922e-08 -0.0984247566766483 +1.5917000000000001 0.704318347500889 0.7043165641705764 -9.596638701498544e-08 -0.09842523143826552 +1.5918 0.704319189206583 0.70431740714335 -1.014316537888485e-07 -0.09842570605792994 +1.5919 0.7043200306011109 0.7043182499215577 -1.0688192742577124e-07 -0.0984261805356833 +1.592 0.7043208716847232 0.704319092505099 -1.123159644508126e-07 -0.09842665487156736 +1.5921 0.7043217124576837 0.7043199348938605 -1.1773252546996849e-07 -0.09842712906562383 +1.5922 0.7043225529202692 0.7043207770877149 -1.2313037545119698e-07 -0.09842760311789445 +1.5923000000000003 0.7043233930727697 0.704321619086522 -1.285082839863616e-07 -0.09842807702842093 +1.5924 0.7043242329154886 0.7043224608901286 -1.338650255991447e-07 -0.098428550797245 +1.5925 0.7043250724487418 0.7043233024983682 -1.391993800121949e-07 -0.09842902442440829 +1.5926000000000002 0.7043259116728586 0.7043241439110612 -1.4451013242294808e-07 -0.09842949790995247 +1.5927 0.704326750588181 0.7043249851280153 -1.4979607377944848e-07 -0.09842997125391924 +1.5928000000000002 0.704327589195064 0.7043258261490257 -1.5505600105963913e-07 -0.09843044445635026 +1.5929 0.7043284274938751 0.7043266669738741 -1.6028871755065233e-07 -0.09843091751728719 +1.593 0.704329265484995 0.7043275076023296 -1.6549303310381402e-07 -0.09843139043677163 +1.5931000000000002 0.7043301031688161 0.7043283480341489 -1.7066776442607734e-07 -0.09843186321484516 +1.5932 0.7043309405457443 0.7043291882690758 -1.758117353263533e-07 -0.09843233585154948 +1.5933000000000002 0.7043317776161978 0.7043300283068417 -1.8092377700867912e-07 -0.09843280834692608 +1.5934000000000001 0.7043326143806068 0.7043308681471653 -1.8600272832028364e-07 -0.0984332807010166 +1.5935 0.7043334508394142 0.7043317077897535 -1.9104743601006113e-07 -0.09843375291386258 +1.5936000000000001 0.7043342869930749 0.7043325472343007 -1.9605675501133124e-07 -0.09843422498550562 +1.5937000000000001 0.7043351228420559 0.7043333864804888 -2.010295486812308e-07 -0.09843469691598725 +1.5938 0.7043359583868365 0.7043342255279883 -2.0596468906786125e-07 -0.09843516870534899 +1.5939 0.7043367936279077 0.704335064376457 -2.1086105718090553e-07 -0.09843564035363236 +1.594 0.7043376285657721 0.7043359030255409 -2.157175432102032e-07 -0.09843611186087886 +1.5941 0.7043384632009448 0.7043367414748749 -2.2053304679636732e-07 -0.09843658322713 +1.5942 0.7043392975339519 0.7043375797240818 -2.253064772875235e-07 -0.09843705445242731 +1.5943000000000003 0.7043401315653313 0.7043384177727725 -2.3003675398911017e-07 -0.09843752553681229 +1.5944 0.7043409652956323 0.7043392556205467 -2.3472280638592302e-07 -0.09843799648032626 +1.5945 0.704341798725415 0.704340093266993 -2.393635743953848e-07 -0.0984384672830108 +1.5946000000000002 0.7043426318552517 0.7043409307116881 -2.4395800860693706e-07 -0.0984389379449073 +1.5947 0.7043434646857251 0.7043417679541986 -2.485050705491876e-07 -0.0984394084660572 +1.5948000000000002 0.7043442972174284 0.7043426049940789 -2.530037328599133e-07 -0.09843987884650184 +1.5949 0.7043451294509668 0.7043434418308736 -2.5745297956708546e-07 -0.09844034908628274 +1.595 0.7043459613869555 0.704344278464116 -2.618518063039754e-07 -0.09844081918544126 +1.5951000000000002 0.7043467930260203 0.7043451148933286 -2.661992205624242e-07 -0.09844128914401873 +1.5952 0.7043476243687976 0.7043459511180239 -2.7049424185937587e-07 -0.09844175896205655 +1.5953000000000002 0.7043484554159343 0.7043467871377038 -2.7473590199361686e-07 -0.09844222863959612 +1.5954000000000002 0.7043492861680871 0.7043476229518597 -2.7892324528516754e-07 -0.09844269817667878 +1.5955 0.704350116625923 0.7043484585599735 -2.830553287487547e-07 -0.0984431675733458 +1.5956000000000001 0.7043509467901187 0.7043492939615164 -2.871312223227951e-07 -0.0984436368296385 +1.5957000000000001 0.7043517766613608 0.7043501291559505 -2.911500090671537e-07 -0.09844410594559827 +1.5958 0.7043526062403458 0.7043509641427279 -2.951107854198831e-07 -0.09844457492126638 +1.5959 0.7043534355277791 0.7043517989212911 -2.990126613394706e-07 -0.09844504375668406 +1.596 0.7043542645243759 0.7043526334910732 -3.0285476054076055e-07 -0.09844551245189265 +1.5961 0.7043550932308605 0.7043534678514985 -3.0663622063720197e-07 -0.09844598100693341 +1.5962 0.7043559216479662 0.7043543020019818 -3.1035619341146514e-07 -0.09844644942184758 +1.5963000000000003 0.7043567497764351 0.7043551359419288 -3.1401384497503626e-07 -0.09844691769667636 +1.5964 0.7043575776170181 0.7043559696707369 -3.176083559347509e-07 -0.09844738583146104 +1.5965 0.7043584051704748 0.7043568031877947 -3.211389215940219e-07 -0.09844785382624283 +1.5966000000000002 0.7043592324375728 0.7043576364924823 -3.246047521054951e-07 -0.09844832168106286 +1.5967 0.7043600594190884 0.7043584695841714 -3.2800507272084944e-07 -0.09844878939596238 +1.5968000000000002 0.7043608861158059 0.704359302462226 -3.313391238879415e-07 -0.09844925697098261 +1.5969 0.7043617125285173 0.7043601351260016 -3.346061614450946e-07 -0.09844972440616466 +1.597 0.7043625386580228 0.7043609675748463 -3.3780545679457097e-07 -0.09845019170154971 +1.5971000000000002 0.7043633645051294 0.7043617998081003 -3.4093629704828876e-07 -0.09845065885717891 +1.5972 0.7043641900706521 0.7043626318250966 -3.4399798525680536e-07 -0.09845112587309335 +1.5973000000000002 0.7043650153554133 0.7043634636251608 -3.4698984041625636e-07 -0.09845159274933422 +1.5974000000000002 0.7043658403602422 0.7043642952076112 -3.4991119775978907e-07 -0.09845205948594261 +1.5975 0.7043666650859746 0.7043651265717592 -3.5276140886858487e-07 -0.09845252608295957 +1.5976000000000001 0.7043674895334533 0.7043659577169099 -3.5553984178982034e-07 -0.09845299254042623 +1.5977000000000001 0.7043683137035279 0.7043667886423612 -3.582458811615674e-07 -0.09845345885838368 +1.5978 0.7043691375970542 0.7043676193474051 -3.6087892840014346e-07 -0.09845392503687295 +1.5979 0.7043699612148941 0.7043684498313268 -3.6343840179725584e-07 -0.09845439107593512 +1.598 0.7043707845579155 0.7043692800934063 -3.6592373666571865e-07 -0.09845485697561125 +1.5981 0.7043716076269919 0.704370110132917 -3.683343854643528e-07 -0.09845532273594233 +1.5982 0.7043724304230028 0.7043709399491269 -3.7066981788819175e-07 -0.0984557883569694 +1.5983000000000003 0.704373252946833 0.7043717695412982 -3.7292952103501475e-07 -0.09845625383873341 +1.5984 0.7043740751993726 0.7043725989086884 -3.7511299950249155e-07 -0.09845671918127541 +1.5985 0.7043748971815164 0.7043734280505497 -3.7721977546451013e-07 -0.09845718438463637 +1.5986000000000002 0.7043757188941648 0.704374256966129 -3.7924938878219905e-07 -0.09845764944885729 +1.5987 0.7043765403382223 0.7043750856546688 -3.812013971357664e-07 -0.09845811437397906 +1.5988000000000002 0.7043773615145981 0.7043759141154069 -3.8307537610776654e-07 -0.09845857916004268 +1.5989 0.7043781824242058 0.7043767423475771 -3.8487091928024464e-07 -0.09845904380708909 +1.599 0.7043790030679626 0.7043775703504086 -3.865876382694311e-07 -0.09845950831515915 +1.5991000000000002 0.7043798234467906 0.7043783981231269 -3.8822516288533615e-07 -0.09845997268429386 +1.5992 0.7043806435616148 0.7043792256649535 -3.897831411803221e-07 -0.09846043691453407 +1.5993000000000002 0.7043814634133639 0.7043800529751068 -3.912612395393089e-07 -0.0984609010059207 +1.5994000000000002 0.7043822830029702 0.7043808800528012 -3.926591427075299e-07 -0.09846136495849461 +1.5995 0.7043831023313685 0.7043817068972484 -3.9397655388073716e-07 -0.09846182877229664 +1.5996000000000001 0.7043839213994973 0.704382533507657 -3.952131948023463e-07 -0.09846229244736769 +1.5997000000000001 0.7043847402082972 0.7043833598832325 -3.9636880574955846e-07 -0.09846275598374854 +1.5998 0.704385558758712 0.7043841860231788 -3.9744314568601613e-07 -0.09846321938148007 +1.5999 0.7043863770516872 0.7043850119266963 -3.984359922201697e-07 -0.09846368264060315 +1.6 0.7043871950881706 0.7043858375929837 -3.9934714167466634e-07 -0.09846414576115846 +1.6001 0.704388012869112 0.7043866630212379 -4.0017640916267805e-07 -0.0984646087431869 +1.6002 0.7043888303954633 0.7043874882106536 -4.0092362857402364e-07 -0.09846507158672921 +1.6003000000000003 0.7043896476681774 0.7043883131604242 -4.0158865270006894e-07 -0.09846553429182618 +1.6004 0.7043904646882082 0.7043891378697418 -4.0217135312270447e-07 -0.09846599685851852 +1.6005 0.7043912814565121 0.7043899623377972 -4.0267162033230663e-07 -0.09846645928684705 +1.6006000000000002 0.704392097974045 0.7043907865637801 -4.030893637624322e-07 -0.0984669215768525 +1.6007 0.7043929142417642 0.7043916105468796 -4.0342451172736826e-07 -0.09846738372857555 +1.6008000000000002 0.7043937302606275 0.7043924342862845 -4.036770115192767e-07 -0.09846784574205694 +1.6009 0.7043945460315925 0.7043932577811831 -4.0384682933186644e-07 -0.09846830761733738 +1.601 0.7043953615556178 0.704394081030763 -4.039339503159045e-07 -0.09846876935445757 +1.6011000000000002 0.7043961768336612 0.7043949040342121 -4.039383785653383e-07 -0.09846923095345818 +1.6012 0.7043969918666804 0.7043957267907197 -4.0386013711035673e-07 -0.09846969241437989 +1.6013000000000002 0.7043978066556325 0.7043965492994736 -4.0369926794514566e-07 -0.09847015373726331 +1.6014000000000002 0.7043986212014743 0.7043973715596636 -4.0345583188911016e-07 -0.09847061492214915 +1.6015 0.7043994355051613 0.7043981935704802 -4.0312990871177456e-07 -0.09847107596907796 +1.6016000000000001 0.7044002495676482 0.7043990153311143 -4.027215970425768e-07 -0.09847153687809049 +1.6017000000000001 0.7044010633898883 0.7043998368407587 -4.022310143639296e-07 -0.09847199764922725 +1.6018000000000001 0.7044018769728329 0.7044006580986075 -4.0165829690019805e-07 -0.09847245828252885 +1.6019 0.7044026903174322 0.7044014791038564 -4.0100359971484423e-07 -0.09847291877803586 +1.602 0.7044035034246345 0.7044022998557032 -4.0026709659940485e-07 -0.09847337913578894 +1.6021 0.7044043162953855 0.7044031203533476 -3.99448979962469e-07 -0.0984738393558286 +1.6022 0.7044051289306292 0.7044039405959914 -3.985494609337614e-07 -0.09847429943819541 +1.6023000000000003 0.7044059413313064 0.7044047605828387 -3.9756876914209816e-07 -0.09847475938292988 +1.6024 0.704406753498356 0.704405580313097 -3.965071528125308e-07 -0.09847521919007253 +1.6025 0.7044075654327133 0.7044063997859759 -3.953648785789965e-07 -0.0984756788596639 +1.6026000000000002 0.704408377135311 0.7044072190006885 -3.9414223148431793e-07 -0.09847613839174452 +1.6027 0.7044091886070784 0.704408037956451 -3.9283951491081437e-07 -0.09847659778635487 +1.6028000000000002 0.7044099998489407 0.7044088566524829 -3.9145705046927937e-07 -0.09847705704353538 +1.6029 0.7044108108618204 0.7044096750880078 -3.899951779434696e-07 -0.09847751616332659 +1.603 0.7044116216466356 0.7044104932622527 -3.8845425522765487e-07 -0.09847797514576895 +1.6031000000000002 0.7044124322043004 0.7044113111744487 -3.8683465818784013e-07 -0.0984784339909029 +1.6032 0.7044132425357246 0.7044121288238314 -3.8513678061319334e-07 -0.09847889269876892 +1.6033000000000002 0.7044140526418133 0.7044129462096403 -3.833610341050231e-07 -0.09847935126940735 +1.6034000000000002 0.7044148625234679 0.70441376333112 -3.815078479935119e-07 -0.09847980970285869 +1.6035 0.7044156721815835 0.7044145801875197 -3.7957766917812163e-07 -0.09848026799916326 +1.6036000000000001 0.7044164816170515 0.7044153967780933 -3.7757096212759356e-07 -0.09848072615836151 +1.6037000000000001 0.7044172908307575 0.7044162131021001 -3.754882086232092e-07 -0.0984811841804938 +1.6038000000000001 0.7044180998235816 0.7044170291588052 -3.7332990777266817e-07 -0.09848164206560049 +1.6039 0.7044189085963988 0.7044178449474785 -3.710965758435547e-07 -0.09848209981372195 +1.604 0.7044197171500779 0.7044186604673959 -3.687887461245598e-07 -0.09848255742489855 +1.6041 0.7044205254854821 0.704419475717839 -3.664069687797644e-07 -0.09848301489917057 +1.6042 0.7044213336034686 0.704420290698096 -3.639518108208839e-07 -0.09848347223657841 +1.6043000000000003 0.7044221415048875 0.7044211054074607 -3.6142385585052894e-07 -0.09848392943716233 +1.6044 0.7044229491905833 0.7044219198452337 -3.588237039858777e-07 -0.09848438650096261 +1.6045 0.7044237566613936 0.7044227340107222 -3.561519717268369e-07 -0.09848484342801957 +1.6046 0.7044245639181488 0.7044235479032401 -3.5340929174787483e-07 -0.09848530021837348 +1.6047 0.7044253709616728 0.704424361522108 -3.5059631284251047e-07 -0.09848575687206457 +1.6048000000000002 0.7044261777927823 0.7044251748666541 -3.4771369966657417e-07 -0.09848621338913312 +1.6049 0.7044269844122866 0.7044259879362136 -3.447621326133077e-07 -0.0984866697696194 +1.605 0.7044277908209875 0.7044268007301291 -3.4174230777866965e-07 -0.09848712601356363 +1.6051000000000002 0.7044285970196789 0.7044276132477507 -3.386549365796965e-07 -0.098487582121006 +1.6052 0.7044294030091469 0.704428425488437 -3.3550074576838007e-07 -0.0984880380919867 +1.6053000000000002 0.7044302087901704 0.7044292374515536 -3.3228047713329545e-07 -0.09848849392654598 +1.6054000000000002 0.7044310143635193 0.7044300491364748 -3.28994887416334e-07 -0.09848894962472404 +1.6055 0.7044318197299552 0.7044308605425826 -3.256447481114755e-07 -0.09848940518656095 +1.6056000000000001 0.7044326248902318 0.7044316716692683 -3.222308452219269e-07 -0.09848986061209697 +1.6057000000000001 0.7044334298450942 0.7044324825159313 -3.1875397921155013e-07 -0.09849031590137225 +1.6058000000000001 0.7044342345952779 0.704433293081979 -3.152149646648561e-07 -0.09849077105442684 +1.6059 0.7044350391415102 0.7044341033668287 -3.1161463019679925e-07 -0.09849122607130094 +1.606 0.7044358434845093 0.7044349133699065 -3.079538181821606e-07 -0.09849168095203466 +1.6061 0.7044366476249841 0.7044357230906473 -3.042333846653422e-07 -0.09849213569666807 +1.6062 0.7044374515636342 0.7044365325284954 -3.0045419906199466e-07 -0.09849259030524128 +1.6063000000000003 0.7044382553011499 0.704437341682905 -2.9661714399595307e-07 -0.09849304477779444 +1.6064 0.704439058838211 0.7044381505533391 -2.927231151049481e-07 -0.0984934991143675 +1.6065 0.7044398621754885 0.7044389591392712 -2.887730207977446e-07 -0.0984939533150006 +1.6066 0.704440665313643 0.7044397674401844 -2.847677821084249e-07 -0.09849440737973375 +1.6067 0.7044414682533257 0.7044405754555714 -2.807083323529136e-07 -0.09849486130860702 +1.6068000000000002 0.7044422709951769 0.7044413831849357 -2.765956170630579e-07 -0.09849531510166043 +1.6069 0.7044430735398269 0.7044421906277899 -2.7243059366396927e-07 -0.09849576875893398 +1.607 0.7044438758878959 0.7044429977836582 -2.6821423129708144e-07 -0.09849622228046766 +1.6071000000000002 0.7044446780399927 0.7044438046520749 -2.6394751057728927e-07 -0.09849667566630145 +1.6072 0.7044454799967165 0.7044446112325846 -2.5963142337784295e-07 -0.09849712891647538 +1.6073000000000002 0.7044462817586551 0.7044454175247431 -2.552669725840173e-07 -0.0984975820310294 +1.6074000000000002 0.7044470833263854 0.7044462235281164 -2.5085517189535333e-07 -0.0984980350100034 +1.6075 0.7044478847004738 0.704447029242282 -2.4639704550993846e-07 -0.0984984878534374 +1.6076000000000001 0.7044486858814749 0.7044478346668286 -2.4189362797868985e-07 -0.09849894056137132 +1.6077000000000001 0.7044494868699327 0.7044486398013554 -2.3734596391739027e-07 -0.09849939313384505 +1.6078000000000001 0.7044502876663797 0.7044494446454737 -2.3275510778811292e-07 -0.09849984557089858 +1.6079 0.7044510882713367 0.7044502491988051 -2.2812212361472683e-07 -0.09850029787257174 +1.608 0.7044518886853133 0.7044510534609836 -2.234480847816689e-07 -0.0985007500389044 +1.6081 0.7044526889088072 0.704451857431655 -2.1873407376332699e-07 -0.0985012020699365 +1.6082 0.7044534889423046 0.7044526611104753 -2.1398118188117876e-07 -0.09850165396570781 +1.6083000000000003 0.7044542887862797 0.7044534644971141 -2.0919050903664416e-07 -0.09850210572625825 +1.6084 0.7044550884411954 0.7044542675912517 -2.0436316347516303e-07 -0.09850255735162769 +1.6085 0.704455887907502 0.7044550703925805 -1.995002615225172e-07 -0.09850300884185592 +1.6086 0.7044566871856377 0.7044558729008052 -1.9460292730380524e-07 -0.0985034601969828 +1.6087 0.7044574862760289 0.7044566751156425 -1.896722925560923e-07 -0.09850391141704808 +1.6088000000000002 0.7044582851790897 0.704457477036821 -1.8470949626411826e-07 -0.09850436250209162 +1.6089 0.7044590838952218 0.7044582786640821 -1.797156844660086e-07 -0.09850481345215317 +1.609 0.7044598824248145 0.7044590799971788 -1.746920099861271e-07 -0.09850526426727248 +1.6091000000000002 0.7044606807682448 0.7044598810358771 -1.6963963214711164e-07 -0.09850571494748933 +1.6092 0.7044614789258771 0.7044606817799552 -1.6455971652527823e-07 -0.09850616549284347 +1.6093000000000002 0.7044622768980633 0.7044614822292041 -1.5945343463316664e-07 -0.09850661590337464 +1.6094000000000002 0.7044630746851428 0.7044622823834273 -1.5432196371831242e-07 -0.09850706617912262 +1.6095 0.7044638722874419 0.7044630822424405 -1.4916648644405783e-07 -0.0985075163201271 +1.6096000000000001 0.7044646697052748 0.7044638818060724 -1.4398819063281276e-07 -0.09850796632642773 +1.6097000000000001 0.7044654669389419 0.7044646810741646 -1.387882689937031e-07 -0.09850841619806423 +1.6098000000000001 0.7044662639887317 0.7044654800465714 -1.3356791883113728e-07 -0.09850886593507632 +1.6099 0.7044670608549197 0.7044662787231601 -1.2832834179674069e-07 -0.0985093155375037 +1.61 0.7044678575377679 0.7044670771038103 -1.2307074359965697e-07 -0.09850976500538591 +1.6101 0.704468654037526 0.7044678751884152 -1.1779633372031861e-07 -0.09851021433876271 +1.6102 0.70446945035443 0.7044686729768808 -1.1250632514676895e-07 -0.09851066353767365 +1.6103000000000003 0.7044702464887035 0.7044694704691258 -1.0720193408496337e-07 -0.09851111260215842 +1.6104 0.7044710424405567 0.7044702676650823 -1.0188437968555036e-07 -0.09851156153225664 +1.6105 0.7044718382101867 0.7044710645646952 -9.655488376631577e-08 -0.09851201032800787 +1.6106 0.7044726337977777 0.7044718611679229 -9.121467052248394e-08 -0.09851245898945175 +1.6107 0.7044734292035004 0.7044726574747364 -8.586496625523354e-08 -0.09851290751662782 +1.6108000000000002 0.7044742244275128 0.7044734534851197 -8.050699907852926e-08 -0.09851335590957568 +1.6109 0.7044750194699592 0.7044742491990708 -7.514199864937232e-08 -0.09851380416833488 +1.611 0.7044758143309708 0.7044750446165999 -6.977119588287214e-08 -0.09851425229294497 +1.6111000000000002 0.704476609010666 0.7044758397377311 -6.439582265994545e-08 -0.09851470028344547 +1.6112 0.7044774035091497 0.7044766345625013 -5.901711156146988e-08 -0.09851514813987593 +1.6113000000000002 0.7044781978265133 0.7044774290909606 -5.3636295571212605e-08 -0.09851559586227586 +1.6114000000000002 0.7044789919628357 0.7044782233231722 -4.825460780055139e-08 -0.09851604345068472 +1.6115 0.7044797859181819 0.7044790172592128 -4.287328120490151e-08 -0.09851649090514204 +1.6116000000000001 0.7044805796926041 0.7044798108991721 -3.749354830008848e-08 -0.09851693822568736 +1.6117000000000001 0.704481373286141 0.7044806042431526 -3.211664088148547e-08 -0.09851738541236002 +1.6118000000000001 0.7044821666988184 0.7044813972912707 -2.674378974287968e-08 -0.09851783246519959 +1.6119 0.7044829599306484 0.7044821900436554 -2.1376224389971915e-08 -0.09851827938424546 +1.612 0.7044837529816306 0.7044829825004488 -1.6015172765206087e-08 -0.09851872616953705 +1.6121 0.7044845458517511 0.7044837746618063 -1.0661860964846642e-08 -0.0985191728211138 +1.6122 0.704485338540983 0.7044845665278961 -5.317512956001802e-09 -0.0985196193390151 +1.6123000000000003 0.7044861310492864 0.7044853580989006 1.6649702450077797e-11 -0.09852006572328048 +1.6124 0.704486923376608 0.704486149375013 5.339408133513135e-09 -0.09852051197394915 +1.6125 0.7044877155228818 0.7044869403564412 1.06495464209308e-08 -0.0985209580910606 +1.6126 0.7044885074880284 0.7044877310434061 1.5945851903655106e-08 -0.09852140407465411 +1.6127 0.704489299271956 0.7044885214361408 2.1227115428248955e-08 -0.0985218499247692 +1.6128000000000002 0.7044900908745595 0.7044893115348915 2.6492131634248128e-08 -0.09852229564144502 +1.6129 0.704490882295721 0.7044901013399172 3.173969924039066e-08 -0.09852274122472103 +1.613 0.70449167353531 0.70449089085149 3.6968621308294813e-08 -0.09852318667463655 +1.6131000000000002 0.7044924645931825 0.7044916800698942 4.2177705513943287e-08 -0.0985236319912308 +1.6132 0.704493255469183 0.7044924689954271 4.736576440789175e-08 -0.09852407717454319 +1.6133000000000002 0.7044940461631419 0.7044932576283985 5.253161572404963e-08 -0.0985245222246129 +1.6134000000000002 0.7044948366748784 0.7044940459691312 5.767408261386775e-08 -0.09852496714147932 +1.6135 0.704495627004198 0.70449483401796 6.279199392389412e-08 -0.09852541192518162 +1.6136000000000001 0.7044964171508945 0.7044956217752323 6.788418445424771e-08 -0.09852585657575914 +1.6137000000000001 0.7044972071147485 0.7044964092413079 7.29494952569909e-08 -0.09852630109325104 +1.6138000000000001 0.7044979968955289 0.704497196416559 7.798677386164354e-08 -0.0985267454776966 +1.6139000000000001 0.7044987864929925 0.7044979833013697 8.299487455273868e-08 -0.09852718972913506 +1.614 0.7044995759068831 0.7044987698961365 8.797265863350057e-08 -0.09852763384760554 +1.6141 0.7045003651369333 0.7044995562012679 9.29189946687059e-08 -0.09852807783314736 +1.6142 0.7045011541828627 0.7045003422171846 9.783275877264797e-08 -0.09852852168579959 +1.6143000000000003 0.7045019430443799 0.7045011279443194 1.0271283483118121e-07 -0.09852896540560152 +1.6144 0.7045027317211807 0.7045019133831161 1.0755811478274646e-07 -0.09852940899259226 +1.6145 0.7045035202129498 0.7045026985340311 1.1236749884388497e-07 -0.09852985244681095 +1.6146 0.7045043085193601 0.7045034833975319 1.171398957659775e-07 -0.09853029576829678 +1.6147 0.7045050966400725 0.7045042679740978 1.218742231093306e-07 -0.0985307389570888 +1.6148000000000002 0.7045058845747372 0.7045050522642196 1.2656940746175183e-07 -0.09853118201322625 +1.6149 0.704506672322992 0.7045058362683991 1.312243846779415e-07 -0.09853162493674814 +1.615 0.7045074598844641 0.7045066199871499 1.3583810013276243e-07 -0.09853206772769359 +1.6151000000000002 0.7045082472587691 0.7045074034209964 1.404095089571622e-07 -0.09853251038610172 +1.6152 0.7045090344455123 0.704508186570474 1.4493757627409565e-07 -0.09853295291201157 +1.6153000000000002 0.7045098214442868 0.7045089694361291 1.494212774691417e-07 -0.09853339530546219 +1.6154000000000002 0.7045106082546759 0.7045097520185193 1.538595983292812e-07 -0.09853383756649273 +1.6155 0.7045113948762516 0.7045105343182123 1.5825153537596393e-07 -0.09853427969514214 +1.6156000000000001 0.7045121813085757 0.7045113163357868 1.6259609601776415e-07 -0.09853472169144953 +1.6157000000000001 0.7045129675511987 0.7045120980718316 1.6689229881405865e-07 -0.09853516355545379 +1.6158000000000001 0.7045137536036616 0.7045128795269464 1.7113917366931575e-07 -0.09853560528719404 +1.6159000000000001 0.7045145394654944 0.7045136607017406 1.7533576209677326e-07 -0.09853604688670922 +1.616 0.7045153251362176 0.7045144415968341 1.7948111739191086e-07 -0.09853648835403839 +1.6161 0.7045161106153415 0.7045152222128561 1.8357430486837245e-07 -0.09853692968922043 +1.6162 0.7045168959023662 0.7045160025504467 1.8761440206266355e-07 -0.09853737089229439 +1.6163000000000003 0.7045176809967826 0.7045167826102551 1.9160049890762365e-07 -0.09853781196329925 +1.6164 0.7045184658980712 0.7045175623929396 1.9553169800304304e-07 -0.09853825290227383 +1.6165 0.7045192506057039 0.7045183418991686 1.9940711476831852e-07 -0.09853869370925714 +1.6166 0.7045200351191427 0.7045191211296196 2.032258776610285e-07 -0.09853913438428807 +1.6167 0.7045208194378407 0.7045199000849791 2.0698712838856936e-07 -0.09853957492740553 +1.6168000000000002 0.7045216035612417 0.704520678765943 2.1069002205040266e-07 -0.09854001533864842 +1.6169 0.7045223874887808 0.7045214571732157 2.143337273739776e-07 -0.09854045561805563 +1.617 0.7045231712198843 0.7045222353075103 2.1791742688820337e-07 -0.09854089576566603 +1.6171000000000002 0.7045239547539699 0.704523013169549 2.2144031709692147e-07 -0.09854133578151854 +1.6172 0.7045247380904469 0.7045237907600619 2.249016086766642e-07 -0.09854177566565196 +1.6173000000000002 0.7045255212287163 0.7045245680797871 2.2830052662931033e-07 -0.09854221541810515 +1.6174000000000002 0.7045263041681706 0.7045253451294712 2.3163631049372135e-07 -0.09854265503891692 +1.6175 0.7045270869081949 0.704526121909869 2.349082144498249e-07 -0.09854309452812612 +1.6176000000000001 0.7045278694481658 0.7045268984217424 2.3811550757535382e-07 -0.0985435338857715 +1.6177000000000001 0.7045286517874534 0.7045276746658615 2.41257473922174e-07 -0.09854397311189195 +1.6178000000000001 0.7045294339254187 0.7045284506430037 2.4433341275220677e-07 -0.09854441220652616 +1.6179000000000001 0.7045302158614168 0.7045292263539538 2.473426386137567e-07 -0.098544851169713 +1.618 0.7045309975947947 0.7045300017995031 2.5028448154967853e-07 -0.09854529000149116 +1.6181 0.7045317791248927 0.704530776980451 2.5315828725697154e-07 -0.09854572870189944 +1.6182 0.7045325604510445 0.7045315518976024 2.5596341719086313e-07 -0.09854616727097655 +1.6183 0.7045333415725767 0.70453232655177 2.586992487174644e-07 -0.09854660570876128 +1.6184 0.70453412248881 0.704533100943772 2.613651752733648e-07 -0.0985470440152923 +1.6185 0.704534903199058 0.7045338750744334 2.63960606490532e-07 -0.09854748219060828 +1.6186 0.7045356837026286 0.7045346489445853 2.664849683142734e-07 -0.09854792023474797 +1.6187 0.7045364639988242 0.7045354225550644 2.6893770311425813e-07 -0.09854835814775008 +1.6188000000000002 0.7045372440869405 0.7045361959067138 2.713182698510508e-07 -0.09854879592965327 +1.6189 0.704538023966268 0.7045369690003811 2.736261441940724e-07 -0.09854923358049616 +1.619 0.7045388036360918 0.7045377418369206 2.7586081857017275e-07 -0.09854967110031748 +1.6191000000000002 0.7045395830956918 0.7045385144171907 2.780218023579195e-07 -0.09855010848915578 +1.6192 0.7045403623443431 0.7045392867420553 2.8010862197086484e-07 -0.0985505457470498 +1.6193000000000002 0.704541141381315 0.7045400588123834 2.8212082091305657e-07 -0.0985509828740381 +1.6194000000000002 0.7045419202058729 0.7045408306290482 2.8405795991781613e-07 -0.09855141987015928 +1.6195 0.7045426988172777 0.7045416021929272 2.8591961708651636e-07 -0.09855185673545196 +1.6196000000000002 0.7045434772147856 0.7045423735049028 2.8770538790245936e-07 -0.09855229346995473 +1.6197000000000001 0.7045442553976489 0.7045431445658612 2.8941488534189874e-07 -0.09855273007370617 +1.6198000000000001 0.7045450333651154 0.7045439153766926 2.9104773997118416e-07 -0.09855316654674481 +1.6199000000000001 0.70454581111643 0.7045446859382908 2.926036000647225e-07 -0.09855360288910925 +1.62 0.7045465886508335 0.704545456251553 2.940821315841613e-07 -0.09855403910083799 +1.6201 0.7045473659675637 0.7045462263173801 2.954830183032886e-07 -0.09855447518196958 +1.6202 0.7045481430658547 0.7045469961366759 2.968059619398722e-07 -0.09855491113254256 +1.6203 0.7045489199449377 0.7045477657103474 2.980506820723927e-07 -0.09855534695259544 +1.6204 0.7045496966040417 0.7045485350393039 2.992169163412717e-07 -0.09855578264216668 +1.6205 0.7045504730423924 0.7045493041244577 3.003044204211158e-07 -0.0985562182012948 +1.6206 0.7045512492592132 0.7045500729667233 3.01312968097045e-07 -0.09855665363001827 +1.6207 0.7045520252537256 0.7045508415670176 3.022423513063255e-07 -0.0985570889283756 +1.6208000000000002 0.7045528010251487 0.7045516099262592 3.030923801869423e-07 -0.09855752409640517 +1.6209 0.7045535765727002 0.7045523780453686 3.038628830775991e-07 -0.09855795913414549 +1.621 0.7045543518955957 0.7045531459252679 3.0455370667731296e-07 -0.09855839404163495 +1.6211000000000002 0.7045551269930499 0.7045539135668804 3.051647158719417e-07 -0.09855882881891204 +1.6212 0.7045559018642753 0.7045546809711309 3.056957939492899e-07 -0.09855926346601504 +1.6213000000000002 0.7045566765084845 0.7045554481389453 3.061468425089031e-07 -0.09855969798298247 +1.6214000000000002 0.7045574509248886 0.70455621507125 3.065177815661513e-07 -0.09856013236985267 +1.6215 0.7045582251126983 0.7045569817689721 3.068085494134509e-07 -0.09856056662666408 +1.6216000000000002 0.7045589990711234 0.7045577482330392 3.070191028423097e-07 -0.098561000753455 +1.6217000000000001 0.704559772799374 0.7045585144643791 3.071494169698541e-07 -0.0985614347502638 +1.6218000000000001 0.7045605462966598 0.7045592804639191 3.071994852874016e-07 -0.09856186861712882 +1.6219000000000001 0.7045613195621908 0.7045600462325876 3.0716931971597194e-07 -0.09856230235408844 +1.622 0.7045620925951772 0.7045608117713112 3.0705895054383703e-07 -0.09856273596118093 +1.6221 0.7045628653948297 0.7045615770810172 3.068684263987653e-07 -0.09856316943844465 +1.6222 0.7045636379603598 0.704562342162631 3.0659781431047195e-07 -0.09856360278591783 +1.6223 0.7045644102909798 0.7045631070170777 3.0624719960653524e-07 -0.09856403600363879 +1.6224 0.7045651823859037 0.7045638716452811 3.0581668590545785e-07 -0.09856446909164585 +1.6225 0.7045659542443459 0.7045646360481638 3.0530639515136127e-07 -0.09856490204997721 +1.6226 0.7045667258655228 0.7045654002266466 3.047164674613301e-07 -0.09856533487867122 +1.6227 0.7045674972486524 0.704566164181649 3.0404706122255654e-07 -0.09856576757776608 +1.6228000000000002 0.704568268392955 0.7045669279140878 3.032983529258071e-07 -0.09856620014730004 +1.6229 0.7045690392976525 0.7045676914248782 3.0247053722093353e-07 -0.09856663258731126 +1.623 0.704569809961969 0.704568454714933 3.015638268058507e-07 -0.09856706489783804 +1.6231000000000002 0.7045705803851314 0.7045692177851628 3.0057845245429204e-07 -0.09856749707891854 +1.6232 0.7045713505663693 0.7045699806364747 2.9951466280764283e-07 -0.098567929130591 +1.6233000000000002 0.7045721205049149 0.7045707432697736 2.9837272446514573e-07 -0.09856836105289354 +1.6234000000000002 0.7045728902000035 0.7045715056859612 2.971529218034896e-07 -0.09856879284586435 +1.6235 0.7045736596508738 0.7045722678859352 2.9585555698374844e-07 -0.0985692245095416 +1.6236000000000002 0.7045744288567676 0.7045730298705912 2.9448094986811446e-07 -0.09856965604396341 +1.6237000000000001 0.704575197816931 0.7045737916408201 2.9302943788805935e-07 -0.09857008744916797 +1.6238000000000001 0.704575966530613 0.704574553197509 2.9150137603045634e-07 -0.09857051872519335 +1.6239000000000001 0.7045767349970674 0.7045753145415415 2.8989713667798567e-07 -0.09857094987207776 +1.624 0.7045775032155515 0.7045760756737964 2.882171096021957e-07 -0.09857138088985914 +1.6241 0.7045782711853275 0.7045768365951489 2.864617018108473e-07 -0.09857181177857577 +1.6242 0.7045790389056619 0.7045775973064685 2.8463133746464697e-07 -0.0985722425382656 +1.6243 0.7045798063758257 0.7045783578086209 2.8272645775928584e-07 -0.09857267316896676 +1.6244 0.7045805735950956 0.7045791181024665 2.807475208629895e-07 -0.09857310367071735 +1.6245 0.7045813405627523 0.7045798781888604 2.7869500173610673e-07 -0.09857353404355533 +1.6246 0.7045821072780828 0.7045806380686526 2.7656939213804854e-07 -0.09857396428751883 +1.6247 0.7045828737403785 0.7045813977426874 2.7437120037748786e-07 -0.09857439440264577 +1.6248000000000002 0.7045836399489376 0.7045821572118038 2.7210095123603173e-07 -0.09857482438897427 +1.6249 0.7045844059030628 0.7045829164768347 2.6975918585026015e-07 -0.09857525424654226 +1.625 0.7045851716020639 0.7045836755386072 2.673464616353982e-07 -0.0985756839753878 +1.6251000000000002 0.7045859370452564 0.7045844343979422 2.648633520771493e-07 -0.09857611357554885 +1.6252 0.7045867022319621 0.7045851930556537 2.623104466206727e-07 -0.09857654304706343 +1.6253000000000002 0.704587467161509 0.7045859515125499 2.5968835053874484e-07 -0.09857697238996942 +1.6254000000000002 0.7045882318332322 0.7045867097694317 2.5699768477216445e-07 -0.09857740160430477 +1.6255 0.7045889962464734 0.7045874678270939 2.5423908579791377e-07 -0.09857783069010749 +1.6256000000000002 0.7045897604005815 0.7045882256863236 2.514132054834417e-07 -0.0985782596474155 +1.6257000000000001 0.7045905242949122 0.704588983347901 2.4852071086461924e-07 -0.09857868847626666 +1.6258000000000001 0.7045912879288285 0.7045897408125991 2.4556228415267833e-07 -0.09857911717669897 +1.6259000000000001 0.7045920513017014 0.704590498081183 2.425386223942061e-07 -0.09857954574875029 +1.626 0.704592814412909 0.7045912551544102 2.3945043740175587e-07 -0.09857997419245847 +1.6261 0.7045935772618372 0.7045920120330309 2.3629845557343598e-07 -0.09858040250786139 +1.6262 0.7045943398478803 0.7045927687177871 2.3308341767780405e-07 -0.09858083069499701 +1.6263 0.7045951021704402 0.704593525209412 2.29806078784478e-07 -0.0985812587539031 +1.6264 0.704595864228927 0.7045942815086315 2.2646720793106923e-07 -0.09858168668461753 +1.6265 0.7045966260227594 0.7045950376161625 2.230675881231825e-07 -0.09858211448717812 +1.6266 0.7045973875513648 0.7045957935327133 2.1960801600134916e-07 -0.09858254216162271 +1.6267 0.7045981488141788 0.704596549258984 2.1608930173000473e-07 -0.09858296970798908 +1.6268000000000002 0.7045989098106462 0.7045973047956655 2.1251226879279161e-07 -0.09858339712631506 +1.6269 0.7045996705402209 0.7045980601434396 2.0887775377051443e-07 -0.09858382441663845 +1.627 0.704600431002365 0.704598815302979 2.051866062197094e-07 -0.098584251578997 +1.6271000000000002 0.7046011911965508 0.7045995702749476 2.014396883708025e-07 -0.09858467861342848 +1.6272 0.7046019511222597 0.7046003250599991 1.9763787506565933e-07 -0.09858510551997067 +1.6273000000000002 0.7046027107789825 0.7046010796587785 1.9378205338635435e-07 -0.09858553229866134 +1.6274000000000002 0.7046034701662193 0.7046018340719205 1.8987312257190414e-07 -0.09858595894953814 +1.6275 0.7046042292834804 0.7046025883000501 1.8591199377540613e-07 -0.09858638547263884 +1.6276000000000002 0.7046049881302863 0.7046033423437827 1.8189958982811616e-07 -0.09858681186800121 +1.6277000000000001 0.7046057467061665 0.7046040962037234 1.7783684506250674e-07 -0.09858723813566285 +1.6278000000000001 0.7046065050106616 0.7046048498804676 1.7372470506246684e-07 -0.09858766427566155 +1.6279000000000001 0.7046072630433216 0.7046056033745995 1.6956412646901287e-07 -0.09858809028803497 +1.628 0.7046080208037074 0.704606356686694 1.653560767408968e-07 -0.09858851617282073 +1.6281 0.7046087782913903 0.7046071098173147 1.6110153391521442e-07 -0.09858894193005655 +1.6282 0.704609535505952 0.7046078627670147 1.568014864061773e-07 -0.09858936755977998 +1.6283 0.7046102924469853 0.7046086155363368 1.5245693278653771e-07 -0.09858979306202884 +1.6284 0.704611049114093 0.7046093681258123 1.480688815447273e-07 -0.09859021843684056 +1.6285 0.7046118055068895 0.7046101205359622 1.4363835080383192e-07 -0.09859064368425284 +1.6286 0.7046125616250002 0.7046108727672964 1.3916636815852756e-07 -0.09859106880430334 +1.6287 0.7046133174680609 0.7046116248203133 1.3465397040446359e-07 -0.0985914937970296 +1.6288000000000002 0.7046140730357195 0.7046123766955001 1.3010220326417632e-07 -0.09859191866246923 +1.6289 0.7046148283276346 0.7046131283933333 1.2551212123443345e-07 -0.0985923434006598 +1.629 0.7046155833434757 0.7046138799142772 1.208847872462282e-07 -0.09859276801163881 +1.6291000000000002 0.7046163380829253 0.7046146312587849 1.1622127246008196e-07 -0.0985931924954439 +1.6292 0.7046170925456758 0.704615382427298 1.1152265602665246e-07 -0.09859361685211257 +1.6293000000000002 0.7046178467314326 0.7046161334202468 1.0679002482999467e-07 -0.0985940410816824 +1.6294000000000002 0.7046186006399114 0.7046168842380488 1.0202447322735231e-07 -0.09859446518419085 +1.6295 0.7046193542708407 0.7046176348811106 9.722710279935765e-08 -0.09859488915967543 +1.6296000000000002 0.7046201076239607 0.7046183853498269 9.2399022121048e-08 -0.09859531300817369 +1.6297000000000001 0.7046208606990232 0.7046191356445796 8.754134645308498e-08 -0.09859573672972305 +1.6298000000000001 0.7046216134957923 0.7046198857657396 8.265519753185291e-08 -0.09859616032436108 +1.6299000000000001 0.7046223660140443 0.7046206357136651 7.774170329016838e-08 -0.09859658379212517 +1.63 0.7046231182535669 0.7046213854887019 7.280199759880646e-08 -0.09859700713305279 +1.6301 0.7046238702141611 0.7046221350911841 6.783722000629211e-08 -0.09859743034718141 +1.6302 0.7046246218956389 0.7046228845214335 6.28485154821612e-08 -0.09859785343454841 +1.6303 0.7046253732978256 0.7046236337797596 5.7837034144608834e-08 -0.09859827639519132 +1.6304 0.7046261244205584 0.7046243828664587 5.280393098987257e-08 -0.09859869922914744 +1.6305 0.7046268752636871 0.7046251317818157 4.775036565630997e-08 -0.09859912193645425 +1.6306 0.7046276258270735 0.7046258805261025 4.267750210347476e-08 -0.0985995445171491 +1.6307 0.7046283761105925 0.7046266290995784 3.758650840048061e-08 -0.09859996697126935 +1.6308000000000002 0.704629126114131 0.7046273775024903 3.247855641895503e-08 -0.09860038929885241 +1.6309 0.704629875837589 0.7046281257350726 2.7354821591912826e-08 -0.09860081149993564 +1.631 0.7046306252808787 0.7046288737975468 2.2216482613648947e-08 -0.0986012335745564 +1.6311000000000002 0.7046313744439253 0.704629621690122 1.7064721190805654e-08 -0.09860165552275202 +1.6312 0.7046321233266662 0.7046303694129945 1.1900721763082045e-08 -0.09860207734455985 +1.6313000000000002 0.7046328719290514 0.7046311169663475 6.72567123174983e-09 -0.0986024990400171 +1.6314000000000002 0.7046336202510444 0.7046318643503522 1.5407586829649378e-09 -0.09860292060916119 +1.6315 0.7046343682926208 0.7046326115651662 -3.6528248750430925e-09 -0.09860334205202936 +1.6316000000000002 0.704635116053769 0.7046333586109348 -8.853886799935207e-09 -0.09860376336865892 +1.6317000000000002 0.7046358635344905 0.7046341054877907 -1.4061233075037677e-08 -0.09860418455908715 +1.6318000000000001 0.7046366107347991 0.7046348521958531 -1.9273668589933624e-08 -0.09860460562335129 +1.6319000000000001 0.7046373576547218 0.7046355987352291 -2.4489997418018772e-08 -0.09860502656148862 +1.632 0.7046381042942984 0.7046363451060123 -2.9709023081263622e-08 -0.09860544737353638 +1.6321 0.704638850653581 0.7046370913082838 -3.492954883557546e-08 -0.09860586805953174 +1.6322 0.704639596732635 0.704637837342112 -4.015037793870472e-08 -0.09860628861951198 +1.6323 0.7046403425315384 0.7046385832075525 -4.537031392346392e-08 -0.09860670905351432 +1.6324 0.7046410880503818 0.7046393289046475 -5.058816087571711e-08 -0.0986071293615759 +1.6325 0.7046418332892692 0.7046400744334272 -5.5802723705538834e-08 -0.098607549543734 +1.6326 0.7046425782483164 0.7046408197939085 -6.101280842097517e-08 -0.09860796960002573 +1.6327 0.7046433229276529 0.7046415649860958 -6.62172224045153e-08 -0.09860838953048828 +1.6328000000000003 0.7046440673274201 0.7046423100099799 -7.141477468414203e-08 -0.0986088093351588 +1.6329 0.7046448114477728 0.70464305486554 -7.660427620362342e-08 -0.09860922901407437 +1.633 0.7046455552888781 0.7046437995527424 -8.178454009421382e-08 -0.09860964856727228 +1.6331000000000002 0.7046462988509158 0.7046445440715396 -8.695438195177596e-08 -0.09861006799478952 +1.6332 0.7046470421340784 0.7046452884218728 -9.211262010175997e-08 -0.09861048729666327 +1.6333000000000002 0.7046477851385711 0.7046460326036696 -9.725807586721813e-08 -0.0986109064729306 +1.6334000000000002 0.7046485278646113 0.7046467766168459 -1.0238957385503428e-07 -0.09861132552362863 +1.6335 0.7046492703124293 0.7046475204613039 -1.0750594219878506e-07 -0.09861174444879438 +1.6336000000000002 0.7046500124822677 0.7046482641369344 -1.1260601283542837e-07 -0.098612163248465 +1.6337000000000002 0.7046507543743815 0.7046490076436149 -1.1768862179240003e-07 -0.09861258192267751 +1.6338000000000001 0.7046514959890384 0.7046497509812111 -1.2275260942266886e-07 -0.09861300047146898 +1.6339000000000001 0.704652237326518 0.7046504941495757 -1.277968206848945e-07 -0.09861341889487646 +1.634 0.7046529783871124 0.7046512371485497 -1.3282010540190126e-07 -0.09861383719293693 +1.6341 0.7046537191711261 0.7046519799779616 -1.3782131853476431e-07 -0.0986142553656875 +1.6342 0.7046544596788753 0.7046527226376271 -1.4279932042914056e-07 -0.0986146734131651 +1.6343 0.7046551999106887 0.7046534651273505 -1.4775297707547708e-07 -0.09861509133540668 +1.6344 0.7046559398669071 0.7046542074469241 -1.5268116037789325e-07 -0.09861550913244936 +1.6345 0.704656679547883 0.7046549495961274 -1.5758274840571573e-07 -0.09861592680433004 +1.6346 0.704657418953981 0.7046556915747287 -1.6245662565021746e-07 -0.09861634435108567 +1.6347 0.7046581580855775 0.7046564333824842 -1.6730168326921369e-07 -0.09861676177275329 +1.6348000000000003 0.7046588969430607 0.7046571750191379 -1.721168193455358e-07 -0.09861717906936973 +1.6349 0.7046596355268302 0.7046579164844224 -1.7690093915764815e-07 -0.09861759624097195 +1.635 0.7046603738372978 0.7046586577780587 -1.8165295537914128e-07 -0.09861801328759692 +1.6351000000000002 0.7046611118748866 0.7046593988997563 -1.8637178837710433e-07 -0.09861843020928157 +1.6352 0.7046618496400304 0.7046601398492127 -1.910563664289655e-07 -0.09861884700606267 +1.6353000000000002 0.7046625871331758 0.7046608806261148 -1.957056259757617e-07 -0.0986192636779773 +1.6354000000000002 0.7046633243547792 0.7046616212301375 -2.0031851186153027e-07 -0.09861968022506218 +1.6355 0.7046640613053092 0.7046623616609451 -2.048939775796399e-07 -0.09862009664735427 +1.6356000000000002 0.7046647979852452 0.7046631019181903 -2.094309854740184e-07 -0.09862051294489044 +1.6357000000000002 0.7046655343950772 0.7046638420015148 -2.139285070305863e-07 -0.09862092911770749 +1.6358000000000001 0.7046662705353064 0.7046645819105497 -2.1838552308889314e-07 -0.09862134516584226 +1.6359000000000001 0.704667006406445 0.704665321644915 -2.2280102402946755e-07 -0.09862176108933163 +1.636 0.7046677420090153 0.70466606120422 -2.2717401007912863e-07 -0.09862217688821234 +1.6361 0.7046684773435508 0.7046668005880639 -2.3150349148445826e-07 -0.09862259256252126 +1.6362 0.7046692124105949 0.7046675397960347 -2.3578848872690683e-07 -0.09862300811229519 +1.6363 0.7046699472107018 0.7046682788277102 -2.4002803279687956e-07 -0.09862342353757089 +1.6364 0.7046706817444355 0.704669017682658 -2.442211653810866e-07 -0.0986238388383851 +1.6365 0.7046714160123704 0.7046697563604362 -2.483669390672405e-07 -0.09862425401477466 +1.6366 0.7046721500150908 0.7046704948605917 -2.5246441756263116e-07 -0.09862466906677629 +1.6367 0.7046728837531906 0.7046712331826623 -2.5651267594392624e-07 -0.09862508399442672 +1.6368000000000003 0.7046736172272745 0.704671971326176 -2.6051080081329614e-07 -0.09862549879776275 +1.6369 0.7046743504379552 0.7046727092906504 -2.644578905239281e-07 -0.09862591347682101 +1.637 0.7046750833858559 0.7046734470755947 -2.6835305540900967e-07 -0.09862632803163823 +1.6371000000000002 0.7046758160716091 0.7046741846805076 -2.721954179413233e-07 -0.09862674246225113 +1.6372 0.7046765484958566 0.7046749221048794 -2.7598411295876035e-07 -0.09862715676869642 +1.6373000000000002 0.7046772806592487 0.7046756593481904 -2.797182878516713e-07 -0.09862757095101074 +1.6374000000000002 0.7046780125624452 0.7046763964099132 -2.8339710274674634e-07 -0.09862798500923078 +1.6375 0.7046787442061146 0.7046771332895102 -2.8701973069089615e-07 -0.0986283989433932 +1.6376000000000002 0.7046794755909342 0.7046778699864358 -2.9058535787676587e-07 -0.09862881275353463 +1.6377000000000002 0.7046802067175892 0.7046786065001356 -2.940931837606964e-07 -0.09862922643969171 +1.6378000000000001 0.7046809375867743 0.7046793428300473 -2.975424213055855e-07 -0.09862964000190115 +1.6379000000000001 0.7046816681991914 0.7046800789755993 -3.009322971439521e-07 -0.09863005344019944 +1.638 0.7046823985555509 0.7046808149362127 -3.042620516924277e-07 -0.09863046675462328 +1.6381000000000001 0.7046831286565715 0.7046815507113007 -3.0753093938074016e-07 -0.09863087994520929 +1.6382 0.7046838585029789 0.7046822863002677 -3.107382288425331e-07 -0.09863129301199396 +1.6383 0.704684588095507 0.7046830217025115 -3.138832029986327e-07 -0.09863170595501387 +1.6384 0.7046853174348974 0.7046837569174218 -3.169651592721534e-07 -0.09863211877430568 +1.6385 0.7046860465218983 0.7046844919443809 -3.199834097203369e-07 -0.09863253146990586 +1.6386 0.7046867753572654 0.7046852267827641 -3.2293728122884113e-07 -0.09863294404185098 +1.6387 0.7046875039417617 0.70468596143194 -3.2582611564357933e-07 -0.09863335649017758 +1.6388000000000003 0.7046882322761567 0.7046866958912694 -3.286492698470478e-07 -0.09863376881492217 +1.6389 0.7046889603612267 0.7046874301601076 -3.31406116015065e-07 -0.0986341810161213 +1.639 0.7046896881977542 0.7046881642378021 -3.3409604168616047e-07 -0.0986345930938114 +1.6391000000000002 0.7046904157865291 0.7046888981236947 -3.3671844989341393e-07 -0.09863500504802902 +1.6392 0.704691143128346 0.7046896318171212 -3.392727593795608e-07 -0.09863541687881064 +1.6393000000000002 0.7046918702240064 0.7046903653174104 -3.4175840460393125e-07 -0.09863582858619266 +1.6394000000000002 0.7046925970743176 0.7046910986238862 -3.4417483592980025e-07 -0.09863624017021162 +1.6395 0.7046933236800927 0.7046918317358665 -3.465215197492877e-07 -0.09863665163090397 +1.6396000000000002 0.7046940500421499 0.7046925646526632 -3.4879793864295294e-07 -0.09863706296830611 +1.6397 0.7046947761613127 0.7046932973735834 -3.5100359138673376e-07 -0.0986374741824545 +1.6398000000000001 0.7046955020384099 0.704694029897929 -3.531379931323575e-07 -0.09863788527338552 +1.6399000000000001 0.7046962276742755 0.7046947622249965 -3.552006755253023e-07 -0.09863829624113558 +1.64 0.7046969530697481 0.704695494354078 -3.5719118678806394e-07 -0.09863870708574111 +1.6401000000000001 0.704697678225671 0.7046962262844605 -3.591090917270945e-07 -0.0986391178072385 +1.6402 0.7046984031428916 0.7046969580154268 -3.6095397205199165e-07 -0.09863952840566412 +1.6403 0.7046991278222619 0.7046976895462554 -3.6272542627141524e-07 -0.0986399388810543 +1.6404 0.7046998522646382 0.7046984208762206 -3.6442306980410955e-07 -0.09864034923344542 +1.6405 0.7047005764708798 0.7046991520045929 -3.6604653513849783e-07 -0.09864075946287383 +1.6406 0.7047013004418508 0.7046998829306388 -3.6759547187431574e-07 -0.0986411695693759 +1.6407 0.704702024178418 0.7047006136536216 -3.690695467920002e-07 -0.09864157955298786 +1.6408000000000003 0.704702747681452 0.7047013441728012 -3.704684438735062e-07 -0.0986419894137461 +1.6409 0.7047034709518265 0.7047020744874335 -3.7179186446190116e-07 -0.09864239915168693 +1.641 0.7047041939904178 0.7047028045967725 -3.7303952735157075e-07 -0.09864280876684658 +1.6411000000000002 0.7047049167981054 0.704703534500069 -3.742111686771965e-07 -0.09864321825926137 +1.6412 0.7047056393757715 0.7047042641965708 -3.753065421358004e-07 -0.09864362762896761 +1.6413000000000002 0.7047063617243001 0.7047049936855236 -3.763254189520504e-07 -0.09864403687600153 +1.6414000000000002 0.7047070838445778 0.7047057229661707 -3.7726758798234394e-07 -0.09864444600039932 +1.6415 0.7047078057374935 0.7047064520377538 -3.7813285565929666e-07 -0.09864485500219733 +1.6416000000000002 0.7047085274039373 0.7047071808995121 -3.7892104613052036e-07 -0.09864526388143174 +1.6417 0.7047092488448012 0.7047079095506832 -3.796320013071952e-07 -0.09864567263813873 +1.6418000000000001 0.7047099700609791 0.7047086379905035 -3.8026558080855866e-07 -0.09864608127235455 +1.6419000000000001 0.7047106910533657 0.704709366218208 -3.808216620243554e-07 -0.09864648978411542 +1.642 0.7047114118228569 0.7047100942330303 -3.8130014016340974e-07 -0.09864689817345748 +1.6421000000000001 0.7047121323703494 0.7047108220342035 -3.8170092823974766e-07 -0.09864730644041693 +1.6422 0.7047128526967407 0.7047115496209597 -3.8202395707953585e-07 -0.09864771458502994 +1.6423 0.7047135728029288 0.7047122769925306 -3.822691753765928e-07 -0.09864812260733268 +1.6424 0.704714292689812 0.7047130041481473 -3.824365496993276e-07 -0.09864853050736128 +1.6425 0.7047150123582887 0.7047137310870413 -3.8252606444910686e-07 -0.09864893828515187 +1.6426 0.7047157318092575 0.7047144578084432 -3.825377218116821e-07 -0.09864934594074061 +1.6427 0.7047164510436162 0.7047151843115849 -3.824715419029068e-07 -0.0986497534741636 +1.6428000000000003 0.7047171700622625 0.7047159105956977 -3.8232756263689716e-07 -0.09865016088545692 +1.6429 0.7047178888660937 0.7047166366600139 -3.8210583977460466e-07 -0.09865056817465669 +1.643 0.7047186074560056 0.7047173625037675 -3.81806446847488e-07 -0.09865097534179904 +1.6431000000000002 0.7047193258328937 0.7047180881261921 -3.814294751852687e-07 -0.09865138238692 +1.6432 0.7047200439976515 0.7047188135265229 -3.8097503390205345e-07 -0.09865178931005562 +1.6433000000000002 0.7047207619511717 0.7047195387039968 -3.8044324975061716e-07 -0.09865219611124196 +1.6434000000000002 0.7047214796943456 0.704720263657852 -3.7983426728199765e-07 -0.09865260279051509 +1.6435 0.7047221972280621 0.7047209883873287 -3.79148248623451e-07 -0.09865300934791105 +1.6436000000000002 0.7047229145532081 0.7047217128916683 -3.783853735686571e-07 -0.09865341578346577 +1.6437 0.7047236316706691 0.7047224371701153 -3.7754583943894193e-07 -0.0986538220972154 +1.6438000000000001 0.7047243485813279 0.704723161221916 -3.766298610555219e-07 -0.09865422828919589 +1.6439000000000001 0.7047250652860644 0.704723885046319 -3.756376707464426e-07 -0.0986546343594432 +1.644 0.7047257817857558 0.7047246086425759 -3.7456951820086237e-07 -0.09865504030799331 +1.6441000000000001 0.7047264980812771 0.7047253320099413 -3.7342567048292974e-07 -0.0986554461348822 +1.6442 0.7047272141734997 0.7047260551476724 -3.7220641186525016e-07 -0.09865585184014591 +1.6443 0.7047279300632916 0.7047267780550299 -3.709120438982749e-07 -0.09865625742382028 +1.6444 0.7047286457515174 0.7047275007312779 -3.6954288524376766e-07 -0.09865666288594124 +1.6445 0.7047293612390384 0.704728223175684 -3.68099271570721e-07 -0.0986570682265448 +1.6446 0.7047300765267119 0.7047289453875198 -3.665815555622953e-07 -0.09865747344566686 +1.6447 0.7047307916153913 0.7047296673660608 -3.6499010674928556e-07 -0.09865787854334332 +1.6448000000000003 0.7047315065059256 0.7047303891105865 -3.6332531151012093e-07 -0.09865828351961009 +1.6449 0.7047322211991598 0.7047311106203804 -3.6158757286963716e-07 -0.09865868837450303 +1.645 0.7047329356959336 0.7047318318947315 -3.597773104713209e-07 -0.09865909310805808 +1.6451000000000002 0.7047336499970829 0.7047325529329326 -3.578949604940429e-07 -0.09865949772031105 +1.6452 0.7047343641034379 0.7047332737342813 -3.5594097547164694e-07 -0.09865990221129776 +1.6453000000000002 0.7047350780158246 0.7047339942980808 -3.539158242374385e-07 -0.09866030658105412 +1.6454000000000002 0.7047357917350632 0.7047347146236396 -3.518199917992848e-07 -0.09866071082961603 +1.6455 0.7047365052619685 0.7047354347102704 -3.496539792702258e-07 -0.09866111495701918 +1.6456000000000002 0.7047372185973498 0.7047361545572929 -3.474183036256129e-07 -0.09866151896329949 +1.6457 0.7047379317420108 0.7047368741640316 -3.4511349771004785e-07 -0.09866192284849269 +1.6458000000000002 0.7047386446967492 0.704737593529817 -3.42740110029216e-07 -0.09866232661263463 +1.6459000000000001 0.7047393574623564 0.704738312653986 -3.4029870470131396e-07 -0.09866273025576107 +1.646 0.704740070039618 0.7047390315358815 -3.377898612419439e-07 -0.09866313377790781 +1.6461000000000001 0.7047407824293129 0.7047397501748525 -3.352141744530912e-07 -0.0986635371791106 +1.6462 0.7047414946322133 0.704740468570255 -3.325722542912857e-07 -0.0986639404594052 +1.6463 0.7047422066490852 0.7047411867214513 -3.2986472568719005e-07 -0.0986643436188274 +1.6464 0.7047429184806866 0.7047419046278109 -3.27092228490089e-07 -0.09866474665741283 +1.6465 0.70474363012777 0.7047426222887101 -3.242554172250278e-07 -0.09866514957519729 +1.6466 0.7047443415910795 0.7047433397035323 -3.213549609540345e-07 -0.09866555237221647 +1.6467 0.7047450528713523 0.7047440568716683 -3.1839154315121965e-07 -0.09866595504850607 +1.6468000000000003 0.7047457639693182 0.7047447737925165 -3.1536586152930424e-07 -0.09866635760410185 +1.6469 0.7047464748856987 0.7047454904654827 -3.122786279008416e-07 -0.09866676003903936 +1.647 0.7047471856212086 0.7047462068899808 -3.0913056790066173e-07 -0.0986671623533544 +1.6471000000000002 0.7047478961765535 0.7047469230654322 -3.0592242093729904e-07 -0.09866756454708253 +1.6472 0.704748606552432 0.7047476389912666 -3.026549399848255e-07 -0.09866796662025949 +1.6473000000000002 0.7047493167495336 0.7047483546669221 -2.993288914197867e-07 -0.09866836857292088 +1.6474000000000002 0.7047500267685401 0.7047490700918446 -2.9594505478527933e-07 -0.09866877040510236 +1.6475 0.7047507366101244 0.7047497852654891 -2.925042226556429e-07 -0.09866917211683957 +1.6476000000000002 0.7047514462749507 0.7047505001873188 -2.8900720043523176e-07 -0.09866957370816806 +1.6477 0.7047521557636744 0.7047512148568054 -2.85454806195351e-07 -0.0986699751791234 +1.6478000000000002 0.7047528650769421 0.7047519292734306 -2.8184787046608983e-07 -0.09867037652974128 +1.6479000000000001 0.7047535742153914 0.7047526434366838 -2.781872359969295e-07 -0.09867077776005723 +1.648 0.7047542831796507 0.7047533573460645 -2.7447375763878235e-07 -0.09867117887010683 +1.6481000000000001 0.7047549919703391 0.7047540710010809 -2.707083020941914e-07 -0.09867157985992564 +1.6482 0.7047557005880656 0.7047547844012512 -2.668917477403887e-07 -0.09867198072954919 +1.6483 0.7047564090334307 0.7047554975461022 -2.630249844037813e-07 -0.09867238147901303 +1.6484 0.7047571173070246 0.7047562104351714 -2.5910891316913154e-07 -0.0986727821083527 +1.6485 0.7047578254094278 0.7047569230680055 -2.5514444614363474e-07 -0.09867318261760373 +1.6486 0.7047585333412107 0.7047576354441611 -2.5113250628344685e-07 -0.09867358300680162 +1.6487 0.7047592411029345 0.7047583475632048 -2.4707402716470095e-07 -0.09867398327598187 +1.6488000000000003 0.704759948695149 0.7047590594247131 -2.4296995274411537e-07 -0.09867438342517992 +1.6489 0.704760656118395 0.7047597710282734 -2.3882123714388803e-07 -0.09867478345443137 +1.649 0.7047613633732017 0.7047604823734828 -2.3462884449210186e-07 -0.09867518336377158 +1.6491000000000002 0.7047620704600885 0.7047611934599489 -2.3039374859659678e-07 -0.09867558315323605 +1.6492 0.7047627773795647 0.7047619042872899 -2.2611693279925293e-07 -0.09867598282286018 +1.6493000000000002 0.704763484132128 0.7047626148551349 -2.2179938971925162e-07 -0.09867638237267946 +1.6494000000000002 0.704764190718266 0.7047633251631231 -2.1744212100674454e-07 -0.09867678180272929 +1.6495 0.7047648971384555 0.7047640352109054 -2.130461371416259e-07 -0.09867718111304515 +1.6496000000000002 0.7047656033931615 0.7047647449981426 -2.0861245719414057e-07 -0.09867758030366236 +1.6497 0.7047663094828389 0.7047654545245071 -2.0414210855773662e-07 -0.09867797937461635 +1.6498000000000002 0.7047670154079311 0.7047661637896825 -1.9963612675824582e-07 -0.0986783783259425 +1.6499000000000001 0.7047677211688705 0.7047668727933631 -1.9509555515898058e-07 -0.09867877715767626 +1.65 0.704768426766078 0.7047675815352548 -1.9052144478032274e-07 -0.09867917586985292 +1.6501000000000001 0.7047691321999631 0.7047682900150744 -1.8591485401175945e-07 -0.09867957446250784 +1.6502000000000001 0.7047698374709239 0.7047689982325507 -1.8127684837943026e-07 -0.09867997293567639 +1.6503 0.7047705425793471 0.7047697061874236 -1.766085003171436e-07 -0.09868037128939389 +1.6504 0.7047712475256078 0.7047704138794444 -1.7191088887147377e-07 -0.09868076952369562 +1.6505 0.7047719523100695 0.7047711213083767 -1.6718509950226779e-07 -0.09868116763861698 +1.6506 0.7047726569330839 0.7047718284739952 -1.6243222382417155e-07 -0.09868156563419328 +1.6507 0.7047733613949909 0.7047725353760861 -1.5765335933080882e-07 -0.09868196351045977 +1.6508000000000003 0.7047740656961183 0.7047732420144478 -1.5284960916406298e-07 -0.09868236126745168 +1.6509 0.7047747698367828 0.7047739483888906 -1.4802208183825605e-07 -0.09868275890520437 +1.651 0.7047754738172882 0.7047746544992368 -1.4317189100422623e-07 -0.0986831564237531 +1.6511000000000002 0.7047761776379272 0.7047753603453205 -1.3830015518391525e-07 -0.09868355382313312 +1.6512 0.7047768812989796 0.7047760659269875 -1.3340799751709875e-07 -0.09868395110337964 +1.6513000000000002 0.7047775848007134 0.7047767712440962 -1.2849654549423883e-07 -0.09868434826452792 +1.6514000000000002 0.7047782881433851 0.7047774762965169 -1.2356693069801028e-07 -0.0986847453066132 +1.6515 0.704778991327238 0.704778181084132 -1.1862028855350037e-07 -0.09868514222967072 +1.6516000000000002 0.704779694352504 0.7047788856068362 -1.1365775805238787e-07 -0.09868553903373566 +1.6517 0.7047803972194019 0.7047795898645359 -1.086804815100817e-07 -0.09868593571884314 +1.6518000000000002 0.7047810999281391 0.7047802938571508 -1.0368960427949159e-07 -0.09868633228502843 +1.6519000000000001 0.70478180247891 0.7047809975846115 -9.868627450122791e-08 -0.09868672873232665 +1.652 0.704782504871897 0.7047817010468621 -9.367164283818896e-08 -0.09868712506077298 +1.6521000000000001 0.7047832071072704 0.7047824042438585 -8.864686220841356e-08 -0.09868752127040259 +1.6522000000000001 0.7047839091851874 0.704783107175569 -8.361308751966834e-08 -0.09868791736125063 +1.6523 0.7047846111057934 0.7047838098419744 -7.857147541704551e-08 -0.09868831333335219 +1.6524 0.7047853128692214 0.7047845122430677 -7.352318399326402e-08 -0.09868870918674245 +1.6525 0.7047860144755913 0.7047852143788544 -6.846937254450722e-08 -0.0986891049214565 +1.6526 0.704786715925011 0.7047859162493525 -6.341120128853031e-08 -0.09868950053752942 +1.6527 0.7047874172175761 0.7047866178545923 -5.83498311118244e-08 -0.09868989603499632 +1.6528000000000003 0.7047881183533699 0.7047873191946165 -5.328642329271126e-08 -0.09869029141389238 +1.6529 0.7047888193324624 0.70478802026948 -4.8222139243303194e-08 -0.09869068667425251 +1.653 0.7047895201549119 0.7047887210792505 -4.3158140234928876e-08 -0.09869108181611183 +1.6531000000000002 0.704790220820764 0.704789421624008 -3.8095587139171626e-08 -0.09869147683950547 +1.6532 0.7047909213300517 0.7047901219038452 -3.303564015681888e-08 -0.09869187174446833 +1.6533000000000002 0.7047916216827961 0.7047908219188663 -2.7979458555160014e-08 -0.09869226653103555 +1.6534 0.7047923218790054 0.7047915216691889 -2.2928200400351012e-08 -0.09869266119924215 +1.6535 0.7047930219186753 0.7047922211549421 -1.7883022296067558e-08 -0.09869305574912308 +1.6536000000000002 0.7047937218017896 0.704792920376268 -1.2845079110177654e-08 -0.09869345018071338 +1.6537 0.7047944215283194 0.7047936193333209 -7.815523722989881e-09 -0.09869384449404804 +1.6538000000000002 0.7047951210982236 0.7047943180262668 -2.795506751432364e-09 -0.09869423868916201 +1.6539000000000001 0.7047958205114488 0.7047950164552851 2.2138237024821317e-09 -0.0986946327660903 +1.654 0.7047965197679292 0.7047957146205666 7.211322324875147e-09 -0.09869502672486792 +1.6541000000000001 0.7047972188675868 0.7047964125223141 1.2195846848042646e-08 -0.09869542056552973 +1.6542000000000001 0.7047979178103316 0.7047971101607434 1.7166258311530902e-08 -0.09869581428811075 +1.6543 0.7047986165960609 0.7047978075360819 2.2121421318875567e-08 -0.09869620789264583 +1.6544 0.7047993152246605 0.7047985046485692 2.7060204296075474e-08 -0.09869660137916993 +1.6545 0.704800013696004 0.704799201498457 3.198147975960741e-08 -0.098696994747718 +1.6546 0.7048007120099521 0.7047998980860088 3.6884124565358944e-08 -0.09869738799832488 +1.6547 0.7048014101663549 0.7048005944115006 4.1767020165367486e-08 -0.09869778113102552 +1.6548000000000003 0.7048021081650495 0.7048012904752194 4.662905286889618e-08 -0.09869817414585477 +1.6549 0.7048028060058615 0.704801986277465 5.1469114083560474e-08 -0.09869856704284748 +1.655 0.704803503688605 0.7048026818185482 5.628610058421024e-08 -0.09869895982203856 +1.6551000000000002 0.7048042012130815 0.7048033770987918 6.10789147575258e-08 -0.09869935248346279 +1.6552 0.7048048985790817 0.7048040721185308 6.584646484140977e-08 -0.09869974502715512 +1.6553000000000002 0.7048055957863839 0.704804766878111 7.058766519560389e-08 -0.09870013745315027 +1.6554 0.7048062928347553 0.7048054613778902 7.530143652373367e-08 -0.09870052976148312 +1.6555 0.7048069897239515 0.7048061556182377 7.99867061421905e-08 -0.09870092195218849 +1.6556000000000002 0.7048076864537167 0.7048068495995337 8.464240821431934e-08 -0.09870131402530116 +1.6557 0.7048083830237839 0.7048075433221702 8.926748398807582e-08 -0.09870170598085594 +1.6558000000000002 0.7048090794338742 0.70480823678655 9.386088203888754e-08 -0.09870209781888756 +1.6559000000000001 0.7048097756836986 0.7048089299930878 9.842155850384171e-08 -0.0987024895394309 +1.656 0.7048104717729557 0.7048096229422083 1.0294847735056734e-07 -0.09870288114252057 +1.6561000000000001 0.7048111677013346 0.7048103156343479 1.0744061055417697e-07 -0.09870327262819147 +1.6562000000000001 0.7048118634685119 0.704811008069954 1.1189693839563919e-07 -0.09870366399647824 +1.6563 0.7048125590741542 0.7048117002494844 1.163164496352509e-07 -0.09870405524741566 +1.6564 0.7048132545179173 0.7048123921734075 1.2069814178325422e-07 -0.0987044463810384 +1.6565 0.7048139497994466 0.7048130838422029 1.2504102131147277e-07 -0.09870483739738123 +1.6566 0.7048146449183763 0.7048137752563604 1.2934410386841733e-07 -0.09870522829647888 +1.6567 0.7048153398743308 0.7048144664163797 1.3360641452908606e-07 -0.09870561907836592 +1.6568000000000003 0.7048160346669239 0.7048151573227718 1.3782698799619242e-07 -0.0987060097430772 +1.6569 0.7048167292957587 0.7048158479760569 1.4200486882220975e-07 -0.09870640029064721 +1.657 0.704817423760429 0.7048165383767662 1.4613911160019089e-07 -0.09870679072111076 +1.6571000000000002 0.704818118060518 0.7048172285254402 1.5022878124479333e-07 -0.0987071810345024 +1.6572 0.7048188121955993 0.7048179184226293 1.542729531275877e-07 -0.09870757123085681 +1.6573000000000002 0.7048195061652365 0.7048186080688941 1.5827071335114407e-07 -0.09870796131020859 +1.6574 0.704820199968984 0.7048192974648048 1.6222115889474864e-07 -0.09870835127259248 +1.6575 0.7048208936063858 0.7048199866109404 1.661233978607346e-07 -0.0987087411180429 +1.6576000000000002 0.7048215870769774 0.7048206755078903 1.6997654966877107e-07 -0.09870913084659463 +1.6577 0.7048222803802842 0.7048213641562523 1.7377974524668272e-07 -0.09870952045828217 +1.6578000000000002 0.7048229735158227 0.7048220525566341 1.7753212722820821e-07 -0.09870990995314011 +1.6579000000000002 0.7048236664831005 0.7048227407096519 1.8123285014381985e-07 -0.09871029933120301 +1.658 0.7048243592816164 0.704823428615931 1.8488108062542086e-07 -0.09871068859250548 +1.6581000000000001 0.7048250519108596 0.7048241162761051 1.8847599756594002e-07 -0.09871107773708204 +1.6582000000000001 0.7048257443703121 0.7048248036908175 1.920167923448457e-07 -0.09871146676496732 +1.6583 0.7048264366594458 0.7048254908607183 1.9550266893569868e-07 -0.09871185567619567 +1.6584 0.7048271287777252 0.7048261777864678 1.989328441802385e-07 -0.09871224447080175 +1.6585 0.7048278207246061 0.7048268644687333 2.023065479132835e-07 -0.09871263314882003 +1.6586 0.7048285124995364 0.7048275509081907 2.0562302315355052e-07 -0.09871302171028502 +1.6587 0.704829204101956 0.7048282371055236 2.0888152622855483e-07 -0.09871341015523119 +1.6588000000000003 0.704829895531297 0.7048289230614233 2.1208132699665483e-07 -0.09871379848369305 +1.6589 0.7048305867869837 0.7048296087765892 2.152217089684827e-07 -0.09871418669570507 +1.659 0.7048312778684334 0.7048302942517275 2.1830196950123337e-07 -0.09871457479130169 +1.6591000000000002 0.7048319687750553 0.7048309794875525 2.2132141993397303e-07 -0.09871496277051743 +1.6592 0.7048326595062515 0.704831664484785 2.2427938576458084e-07 -0.09871535063338666 +1.6593000000000002 0.7048333500614177 0.7048323492441532 2.2717520677811853e-07 -0.09871573837994387 +1.6594 0.7048340404399419 0.7048330337663921 2.3000823720642494e-07 -0.09871612601022342 +1.6595 0.7048347306412055 0.7048337180522434 2.327778458391383e-07 -0.09871651352425974 +1.6596000000000002 0.7048354206645836 0.7048344021024555 2.354834162110464e-07 -0.09871690092208726 +1.6597 0.7048361105094447 0.704835085917783 2.3812434670617e-07 -0.09871728820374033 +1.6598000000000002 0.704836800175151 0.7048357694989871 2.407000507451129e-07 -0.09871767536925341 +1.6599000000000002 0.7048374896610587 0.704836452846834 2.4320995682669544e-07 -0.09871806241866074 +1.66 0.7048381789665179 0.7048371359620975 2.4565350870142666e-07 -0.0987184493519968 +1.6601000000000001 0.7048388680908731 0.7048378188455562 2.480301655449768e-07 -0.09871883616929594 +1.6602000000000001 0.704839557033463 0.7048385014979937 2.5033940198593285e-07 -0.09871922287059244 +1.6603 0.7048402457936209 0.7048391839202004 2.525807082931486e-07 -0.09871960945592073 +1.6604 0.7048409343706747 0.704839866112971 2.547535904104392e-07 -0.09871999592531505 +1.6605 0.7048416227639476 0.7048405480771054 2.5685757018556465e-07 -0.09872038227880975 +1.6606 0.7048423109727573 0.7048412298134086 2.5889218534941305e-07 -0.09872076851643911 +1.6607 0.7048429989964168 0.70484191132269 2.60856989689473e-07 -0.09872115463823739 +1.6608000000000003 0.7048436868342348 0.7048425926057644 2.627515531400393e-07 -0.09872154064423895 +1.6609 0.7048443744855157 0.70484327366345 2.6457546184466274e-07 -0.09872192653447803 +1.661 0.7048450619495592 0.7048439544965699 2.663283182879894e-07 -0.09872231230898891 +1.6611000000000002 0.7048457492256611 0.7048446351059509 2.6800974133045496e-07 -0.09872269796780583 +1.6612 0.7048464363131133 0.7048453154924235 2.696193663401236e-07 -0.09872308351096303 +1.6613000000000002 0.7048471232112044 0.7048459956568223 2.7115684529677164e-07 -0.09872346893849476 +1.6614 0.7048478099192186 0.7048466755999854 2.72621846743315e-07 -0.09872385425043528 +1.6615 0.7048484964364372 0.7048473553227536 2.740140560286708e-07 -0.09872423944681871 +1.6616000000000002 0.7048491827621386 0.7048480348259716 2.753331751967347e-07 -0.09872462452767934 +1.6617 0.7048498688955976 0.7048487141104869 2.7657892319454813e-07 -0.09872500949305132 +1.6618000000000002 0.7048505548360866 0.7048493931771496 2.777510358445423e-07 -0.09872539434296884 +1.6619000000000002 0.7048512405828753 0.7048500720268124 2.788492659624997e-07 -0.0987257790774661 +1.662 0.7048519261352308 0.7048507506603303 2.7987338335061507e-07 -0.09872616369657722 +1.6621000000000001 0.7048526114924181 0.704851429078561 2.8082317486688435e-07 -0.0987265482003364 +1.6622000000000001 0.7048532966537 0.7048521072823641 2.8169844450143255e-07 -0.09872693258877782 +1.6623 0.7048539816183373 0.7048527852726008 2.8249901336957484e-07 -0.09872731686193555 +1.6624 0.7048546663855892 0.704853463050134 2.8322471977426655e-07 -0.09872770101984371 +1.6625 0.7048553509547135 0.7048541406158285 2.8387541921304216e-07 -0.09872808506253647 +1.6626 0.7048560353249664 0.7048548179705502 2.8445098444046524e-07 -0.09872846899004793 +1.6627 0.7048567194956028 0.704855495115166 2.849513054889452e-07 -0.09872885280241217 +1.6628000000000003 0.7048574034658771 0.7048561720505437 2.853762896826151e-07 -0.09872923649966325 +1.6629 0.7048580872350425 0.7048568487775524 2.85725861602637e-07 -0.09872962008183529 +1.663 0.7048587708023519 0.704857525297061 2.8599996317046905e-07 -0.09873000354896237 +1.6631000000000002 0.704859454167057 0.7048582016099394 2.861985536201095e-07 -0.09873038690107842 +1.6632 0.7048601373284105 0.7048588777170577 2.863216095397303e-07 -0.09873077013821767 +1.6633000000000002 0.7048608202856641 0.7048595536192857 2.8636912483004373e-07 -0.09873115326041404 +1.6634 0.7048615030380697 0.7048602293174928 2.8634111069736345e-07 -0.09873153626770159 +1.6635 0.7048621855848802 0.7048609048125491 2.86237595688299e-07 -0.09873191916011438 +1.6636000000000002 0.7048628679253481 0.7048615801053233 2.8605862564812234e-07 -0.09873230193768638 +1.6637 0.704863550058727 0.7048622551966832 2.858042636860736e-07 -0.09873268460045156 +1.6638000000000002 0.7048642319842717 0.7048629300874962 2.854745902100553e-07 -0.09873306714844396 +1.6639000000000002 0.7048649137012377 0.704863604778629 2.850697028849991e-07 -0.09873344958169757 +1.664 0.7048655952088815 0.704864279270946 2.845897165495992e-07 -0.09873383190024633 +1.6641000000000001 0.7048662765064613 0.7048649535653106 2.840347632648843e-07 -0.09873421410412418 +1.6642000000000001 0.7048669575932367 0.7048656276625849 2.8340499223095117e-07 -0.0987345961933651 +1.6643000000000001 0.7048676384684698 0.7048663015636286 2.8270056978002556e-07 -0.09873497816800303 +1.6644 0.7048683191314237 0.7048669752693 2.819216792723789e-07 -0.09873536002807187 +1.6645 0.7048689995813642 0.7048676487804547 2.8106852113796155e-07 -0.09873574177360556 +1.6646 0.7048696798175589 0.7048683220979461 2.801413127515029e-07 -0.09873612340463798 +1.6647 0.7048703598392794 0.7048689952226252 2.791402883978167e-07 -0.09873650492120313 +1.6648000000000003 0.7048710396457982 0.7048696681553401 2.7806569924404556e-07 -0.09873688632333483 +1.6649 0.7048717192363912 0.7048703408969361 2.769178132494554e-07 -0.09873726761106692 +1.665 0.704872398610338 0.7048710134482552 2.7569691508910754e-07 -0.09873764878443335 +1.6651000000000002 0.7048730777669212 0.7048716858101365 2.7440330607753083e-07 -0.09873802984346797 +1.6652 0.704873756705426 0.7048723579834151 2.7303730417566063e-07 -0.09873841078820461 +1.6653000000000002 0.7048744354251422 0.704873029968923 2.7159924381042755e-07 -0.0987387916186771 +1.6654 0.7048751139253627 0.7048737017674883 2.7008947583312404e-07 -0.09873917233491931 +1.6655 0.7048757922053847 0.7048743733799347 2.685083674638933e-07 -0.09873955293696497 +1.6656000000000002 0.7048764702645096 0.7048750448070827 2.668563021529513e-07 -0.09873993342484809 +1.6657 0.7048771481020426 0.7048757160497475 2.6513367950425915e-07 -0.0987403137986023 +1.6658000000000002 0.7048778257172938 0.70487638710874 2.633409152061339e-07 -0.09874069405826144 +1.6659000000000002 0.7048785031095777 0.7048770579848669 2.6147844090634864e-07 -0.0987410742038593 +1.666 0.7048791802782138 0.7048777286789294 2.5954670408029346e-07 -0.09874145423542964 +1.6661000000000001 0.7048798572225264 0.7048783991917242 2.575461680170976e-07 -0.09874183415300622 +1.6662000000000001 0.7048805339418451 0.7048790695240432 2.554773116114628e-07 -0.09874221395662287 +1.6663000000000001 0.7048812104355044 0.7048797396766722 2.533406292595797e-07 -0.09874259364631327 +1.6664 0.7048818867028445 0.7048804096503916 2.511366308244334e-07 -0.09874297322211113 +1.6665 0.7048825627432115 0.7048810794459761 2.488658414068201e-07 -0.09874335268405021 +1.6666 0.7048832385559567 0.7048817490641952 2.465288012898359e-07 -0.09874373203216419 +1.6667 0.7048839141404385 0.7048824185058121 2.4412606581397656e-07 -0.09874411126648691 +1.6668000000000003 0.7048845894960198 0.7048830877715835 2.4165820518978753e-07 -0.09874449038705191 +1.6669 0.7048852646220709 0.7048837568622599 2.391258044145972e-07 -0.0987448693938929 +1.667 0.7048859395179683 0.7048844257785856 2.3652946310598333e-07 -0.09874524828704362 +1.6671 0.7048866141830947 0.7048850945212983 2.3386979539075092e-07 -0.0987456270665377 +1.6672 0.70488728861684 0.7048857630911289 2.3114742968982638e-07 -0.09874600573240877 +1.6673000000000002 0.7048879628186009 0.7048864314888013 2.2836300868356307e-07 -0.0987463842846906 +1.6674 0.7048886367877811 0.7048870997150322 2.255171890550023e-07 -0.09874676272341674 +1.6675 0.7048893105237912 0.7048877677705312 2.2261064139966757e-07 -0.09874714104862081 +1.6676000000000002 0.7048899840260495 0.7048884356560005 2.1964405000352016e-07 -0.09874751926033648 +1.6677 0.7048906572939815 0.7048891033721347 2.1661811276663112e-07 -0.09874789735859728 +1.6678000000000002 0.7048913303270204 0.7048897709196211 2.1353354096032007e-07 -0.09874827534343684 +1.6679000000000002 0.7048920031246073 0.7048904382991387 2.1039105912654121e-07 -0.09874865321488874 +1.668 0.7048926756861912 0.7048911055113589 2.071914048662471e-07 -0.09874903097298658 +1.6681000000000001 0.7048933480112289 0.7048917725569452 2.0393532866938568e-07 -0.09874940861776393 +1.6682000000000001 0.704894020099186 0.7048924394365528 2.0062359374489747e-07 -0.09874978614925442 +1.6683000000000001 0.7048946919495356 0.7048931061508279 1.9725697585765145e-07 -0.09875016356749153 +1.6684 0.7048953635617592 0.7048937727004092 1.9383626310987e-07 -0.09875054087250879 +1.6685 0.7048960349353477 0.7048944390859259 1.903622557954121e-07 -0.09875091806433973 +1.6686 0.7048967060698 0.7048951053079991 1.8683576620548425e-07 -0.09875129514301792 +1.6687 0.7048973769646244 0.7048957713672408 1.8325761841006538e-07 -0.09875167210857683 +1.6688000000000003 0.7048980476193375 0.7048964372642541 1.796286481017817e-07 -0.09875204896104994 +1.6689 0.7048987180334654 0.7048971029996329 1.75949702380801e-07 -0.09875242570047081 +1.669 0.7048993882065433 0.7048977685739619 1.722216395397269e-07 -0.09875280232687288 +1.6691 0.7049000581381155 0.7048984339878163 1.6844532891788222e-07 -0.09875317884028958 +1.6692 0.7049007278277364 0.7048990992417625 1.6462165065844747e-07 -0.09875355524075452 +1.6693000000000002 0.7049013972749691 0.7048997643363565 1.60751495514172e-07 -0.09875393152830106 +1.6694 0.7049020664793867 0.704900429272145 1.568357646079821e-07 -0.09875430770296262 +1.6695 0.7049027354405719 0.704901094049665 1.5287536926644751e-07 -0.09875468376477269 +1.6696000000000002 0.7049034041581178 0.7049017586694433 1.4887123080814524e-07 -0.09875505971376464 +1.6697 0.7049040726316268 0.7049024231319969 1.4482428032161487e-07 -0.09875543554997193 +1.6698000000000002 0.7049047408607118 0.7049030874378328 1.4073545840861956e-07 -0.09875581127342797 +1.6699000000000002 0.7049054088449955 0.7049037515874474 1.3660571502108199e-07 -0.0987561868841661 +1.67 0.7049060765841113 0.7049044155813272 1.3243600922516197e-07 -0.09875656238221975 +1.6701000000000001 0.7049067440777027 0.7049050794199483 1.2822730896186463e-07 -0.0987569377676223 +1.6702000000000001 0.7049074113254239 0.704905743103776 1.2398059082846524e-07 -0.09875731304040714 +1.6703000000000001 0.704908078326939 0.7049064066332651 1.1969683985646462e-07 -0.09875768820060755 +1.6704 0.7049087450819237 0.7049070700088598 1.153770492964834e-07 -0.09875806324825695 +1.6705 0.7049094115900634 0.7049077332309939 1.1102222036846188e-07 -0.09875843818338863 +1.6706 0.7049100778510551 0.70490839630009 1.0663336203614593e-07 -0.09875881300603596 +1.6707 0.7049107438646064 0.7049090592165592 1.0221149077116465e-07 -0.09875918771623224 +1.6708000000000003 0.7049114096304356 0.7049097219808032 9.775763032404683e-08 -0.0987595623140108 +1.6709 0.7049120751482725 0.704910384593211 9.327281148135969e-08 -0.09875993679940491 +1.671 0.7049127404178578 0.7049110470541613 8.875807181590867e-08 -0.09876031117244789 +1.6711 0.7049134054389432 0.7049117093640214 8.421445549244844e-08 -0.098760685433173 +1.6712 0.7049140702112918 0.7049123715231473 7.964301296237153e-08 -0.09876105958161352 +1.6713000000000002 0.704914734734678 0.7049130335318838 7.504480077115405e-08 -0.0987614336178027 +1.6714 0.7049153990088879 0.7049136953905641 7.042088129120827e-08 -0.09876180754177383 +1.6715 0.7049160630337182 0.70491435709951 6.577232247555187e-08 -0.09876218135356009 +1.6716000000000002 0.7049167268089778 0.7049150186590322 6.110019762535501e-08 -0.0987625550531948 +1.6717 0.7049173903344871 0.7049156800694288 5.640558513146654e-08 -0.09876292864071112 +1.6718000000000002 0.7049180536100775 0.7049163413309875 5.168956821940962e-08 -0.09876330211614227 +1.6719000000000002 0.7049187166355928 0.7049170024439831 4.695323471866353e-08 -0.09876367547952147 +1.672 0.7049193794108879 0.70491766340868 4.219767679725095e-08 -0.0987640487308819 +1.6721000000000001 0.7049200419358299 0.7049183242253296 3.742399072408087e-08 -0.09876442187025677 +1.6722000000000001 0.7049207042102973 0.7049189848941724 3.263327658098447e-08 -0.09876479489767924 +1.6723000000000001 0.7049213662341804 0.7049196454154366 2.782663805628305e-08 -0.09876516781318248 +1.6724 0.7049220280073818 0.7049203057893384 2.3005182165497517e-08 -0.09876554061679962 +1.6725 0.7049226895298153 0.7049209660160827 1.8170018997211435e-08 -0.09876591330856385 +1.6726 0.7049233508014072 0.7049216260958618 1.3322261458066642e-08 -0.09876628588850828 +1.6727 0.7049240118220957 0.7049222860288564 8.463025020361004e-09 -0.09876665835666605 +1.6728000000000003 0.7049246725918304 0.7049229458152351 3.5934274679114142e-09 -0.09876703071307026 +1.6729 0.7049253331105737 0.7049236054551546 -1.2854113710936144e-09 -0.09876740295775413 +1.673 0.704925993378299 0.7049242649487595 -6.172369872159411e-09 -0.09876777509075062 +1.6731 0.7049266533949925 0.7049249242961819 -1.1066324872091582e-08 -0.09876814711209285 +1.6732 0.7049273131606522 0.7049255834975428 -1.5966151934842382e-08 -0.0987685190218139 +1.6733000000000002 0.704927972675288 0.7049262425529501 -2.0870725604346663e-08 -0.0987688908199469 +1.6734 0.7049286319389219 0.7049269014625001 -2.5778919661694627e-08 -0.09876926250652479 +1.6735 0.7049292909515881 0.7049275602262773 -3.068960739054452e-08 -0.09876963408158068 +1.6736000000000002 0.7049299497133328 0.7049282188443537 -3.560166182583861e-08 -0.09877000554514763 +1.6737 0.7049306082242142 0.7049288773167894 -4.051395601954114e-08 -0.09877037689725865 +1.6738000000000002 0.7049312664843024 0.7049295356436325 -4.542536329713346e-08 -0.09877074813794683 +1.6739000000000002 0.7049319244936803 0.7049301938249188 -5.0334757514597026e-08 -0.09877111926724513 +1.674 0.7049325822524416 0.7049308518606721 -5.524101331965195e-08 -0.0987714902851866 +1.6741000000000001 0.7049332397606931 0.704931509750904 -6.014300640497239e-08 -0.09877186119180417 +1.6742000000000001 0.704933897018553 0.7049321674956144 -6.503961377324688e-08 -0.09877223198713088 +1.6743000000000001 0.7049345540261516 0.7049328250947908 -6.992971398559616e-08 -0.09877260267119965 +1.6744 0.7049352107836311 0.7049334825484089 -7.481218741983015e-08 -0.09877297324404344 +1.6745 0.7049358672911459 0.7049341398564324 -7.968591653889634e-08 -0.09877334370569521 +1.6746 0.7049365235488625 0.7049347970188133 -8.45497861263686e-08 -0.098773714056188 +1.6747 0.7049371795569588 0.7049354540354912 -8.940268355663028e-08 -0.09877408429555462 +1.6748000000000003 0.7049378353156248 0.7049361109063939 -9.424349904293972e-08 -0.09877445442382812 +1.6749 0.7049384908250624 0.7049367676314378 -9.907112589677136e-08 -0.09877482444104138 +1.675 0.7049391460854849 0.7049374242105266 -1.0388446077327917e-07 -0.09877519434722723 +1.6751 0.704939801097118 0.7049380806435532 -1.0868240393150513e-07 -0.09877556414241867 +1.6752 0.7049404558601984 0.7049387369303981 -1.1346385947810789e-07 -0.0987759338266485 +1.6753000000000002 0.704941110374975 0.7049393930709301 -1.1822773561542821e-07 -0.09877630339994964 +1.6754 0.7049417646417082 0.7049400490650068 -1.229729449069017e-07 -0.09877667286235499 +1.6755 0.7049424186606699 0.7049407049124736 -1.2769840450344017e-07 -0.09877704221389737 +1.6756000000000002 0.7049430724321437 0.7049413606131649 -1.3240303640971174e-07 -0.09877741145460966 +1.6757 0.7049437259564246 0.7049420161669031 -1.3708576772179792e-07 -0.09877778058452472 +1.6758000000000002 0.7049443792338188 0.7049426715734997 -1.4174553085964658e-07 -0.09877814960367534 +1.6759000000000002 0.7049450322646437 0.704943326832754 -1.4638126383595407e-07 -0.09877851851209432 +1.676 0.7049456850492285 0.7049439819444548 -1.5099191047474037e-07 -0.09877888730981449 +1.6761000000000001 0.7049463375879136 0.7049446369083796 -1.5557642067155764e-07 -0.09877925599686871 +1.6762000000000001 0.7049469898810501 0.7049452917242942 -1.601337506155348e-07 -0.09877962457328975 +1.6763000000000001 0.7049476419290004 0.7049459463919538 -1.646628630339736e-07 -0.09877999303911039 +1.6764000000000001 0.7049482937321383 0.7049466009111018 -1.6916272742480143e-07 -0.09878036139436341 +1.6765 0.7049489452908475 0.7049472552814714 -1.7363232030637166e-07 -0.09878072963908154 +1.6766 0.7049495966055238 0.7049479095027846 -1.7807062542563035e-07 -0.09878109777329756 +1.6767 0.704950247676573 0.7049485635747528 -1.8247663402179426e-07 -0.09878146579704422 +1.6768000000000003 0.7049508985044117 0.7049492174970762 -1.8684934500329264e-07 -0.09878183371035426 +1.6769 0.7049515490894677 0.7049498712694449 -1.9118776523746606e-07 -0.09878220151326045 +1.677 0.7049521994321782 0.7049505248915378 -1.954909097309776e-07 -0.09878256920579542 +1.6771 0.7049528495329919 0.7049511783630239 -1.9975780187614367e-07 -0.09878293678799194 +1.6772 0.7049534993923672 0.7049518316835619 -2.039874736556313e-07 -0.09878330425988271 +1.6773000000000002 0.704954149010773 0.7049524848527997 -2.0817896588878892e-07 -0.09878367162150042 +1.6774 0.7049547983886886 0.7049531378703757 -2.1233132840858815e-07 -0.09878403887287779 +1.6775 0.7049554475266024 0.7049537907359172 -2.164436203079545e-07 -0.09878440601404737 +1.6776000000000002 0.7049560964250138 0.7049544434490426 -2.2051491015140368e-07 -0.09878477304504191 +1.6777 0.7049567450844314 0.7049550960093598 -2.2454427618320838e-07 -0.09878513996589405 +1.6778000000000002 0.7049573935053741 0.7049557484164671 -2.2853080650780955e-07 -0.09878550677663644 +1.6779000000000002 0.7049580416883696 0.7049564006699529 -2.3247359934655543e-07 -0.0987858734773017 +1.678 0.7049586896339561 0.7049570527693967 -2.3637176321811282e-07 -0.09878624006792244 +1.6781000000000001 0.7049593373426803 0.7049577047143678 -2.4022441711540887e-07 -0.0987866065485313 +1.6782000000000001 0.7049599848150989 0.7049583565044271 -2.4403069074502293e-07 -0.09878697291916093 +1.6783000000000001 0.7049606320517774 0.7049590081391248 -2.4778972467984217e-07 -0.09878733917984384 +1.6784000000000001 0.7049612790532904 0.7049596596180033 -2.515006706053924e-07 -0.09878770533061265 +1.6785 0.7049619258202213 0.704960310940596 -2.551626914724936e-07 -0.09878807137149995 +1.6786 0.7049625723531628 0.7049609621064268 -2.5877496171583525e-07 -0.09878843730253833 +1.6787 0.7049632186527156 0.7049616131150112 -2.623366674031624e-07 -0.0987888031237603 +1.6788000000000003 0.7049638647194896 0.704962263965856 -2.658470064191565e-07 -0.09878916883519842 +1.6789 0.7049645105541026 0.70496291465846 -2.693051887117659e-07 -0.09878953443688528 +1.679 0.7049651561571811 0.704963565192313 -2.727104363858812e-07 -0.09878989992885338 +1.6791 0.7049658015293594 0.7049642155668969 -2.760619839149714e-07 -0.0987902653111352 +1.6792 0.7049664466712803 0.7049648657816857 -2.793590783457811e-07 -0.09879063058376329 +1.6793000000000002 0.7049670915835939 0.7049655158361454 -2.8260097940241424e-07 -0.09879099574677014 +1.6794 0.7049677362669586 0.7049661657297339 -2.8578695968756174e-07 -0.09879136080018829 +1.6795 0.7049683807220402 0.7049668154619015 -2.8891630484556563e-07 -0.0987917257440501 +1.6796000000000002 0.704969024949512 0.7049674650320916 -2.9198831374629974e-07 -0.09879209057838823 +1.6797 0.7049696689500546 0.7049681144397397 -2.950022985892531e-07 -0.09879245530323502 +1.6798000000000002 0.7049703127243554 0.7049687636842741 -2.9795758506659387e-07 -0.09879281991862293 +1.6799000000000002 0.7049709562731097 0.7049694127651162 -3.008535125713363e-07 -0.09879318442458446 +1.68 0.7049715995970187 0.7049700616816803 -3.0368943428754624e-07 -0.09879354882115199 +1.6801000000000001 0.7049722426967913 0.7049707104333739 -3.064647173534052e-07 -0.09879391310835794 +1.6802000000000001 0.7049728855731423 0.7049713590195983 -3.091787429826409e-07 -0.0987942772862348 +1.6803000000000001 0.7049735282267935 0.7049720074397476 -3.1183090663799984e-07 -0.09879464135481493 +1.6804000000000001 0.7049741706584722 0.7049726556932105 -3.1442061814573874e-07 -0.09879500531413073 +1.6805 0.7049748128689128 0.7049733037793688 -3.169473018205249e-07 -0.09879536916421462 +1.6806 0.7049754548588547 0.7049739516975984 -3.1941039662503057e-07 -0.09879573290509891 +1.6807 0.7049760966290439 0.7049745994472695 -3.2180935623238316e-07 -0.09879609653681608 +1.6808 0.7049767381802314 0.7049752470277466 -3.241436492343319e-07 -0.09879646005939836 +1.6809 0.7049773795131745 0.7049758944383888 -3.2641275918982027e-07 -0.09879682347287824 +1.681 0.7049780206286351 0.7049765416785497 -3.2861618474294696e-07 -0.09879718677728795 +1.6811 0.7049786615273805 0.7049771887475778 -3.307534397686829e-07 -0.09879754997265992 +1.6812 0.7049793022101829 0.7049778356448162 -3.3282405345613775e-07 -0.09879791305902641 +1.6813000000000002 0.7049799426778197 0.7049784823696035 -3.3482757041958244e-07 -0.09879827603641973 +1.6814 0.7049805829310726 0.7049791289212733 -3.367635507955935e-07 -0.0987986389048722 +1.6815 0.7049812229707282 0.7049797752991553 -3.3863157034713653e-07 -0.09879900166441617 +1.6816000000000002 0.7049818627975768 0.7049804215025741 -3.4043122052601626e-07 -0.09879936431508386 +1.6817 0.7049825024124136 0.7049810675308503 -3.421621086255322e-07 -0.09879972685690758 +1.6818000000000002 0.7049831418160372 0.7049817133833007 -3.438238578012953e-07 -0.09880008928991961 +1.6819000000000002 0.7049837810092501 0.7049823590592379 -3.4541610718918925e-07 -0.09880045161415213 +1.682 0.7049844199928589 0.7049830045579712 -3.4693851194006475e-07 -0.09880081382963746 +1.6821000000000002 0.7049850587676736 0.7049836498788062 -3.483907433793343e-07 -0.09880117593640786 +1.6822000000000001 0.7049856973345068 0.7049842950210452 -3.4977248897227753e-07 -0.09880153793449552 +1.6823000000000001 0.7049863356941752 0.7049849399839869 -3.5108345248363593e-07 -0.09880189982393267 +1.6824000000000001 0.7049869738474978 0.7049855847669275 -3.523233539984294e-07 -0.0988022616047515 +1.6825 0.7049876117952965 0.7049862293691604 -3.534919299358341e-07 -0.09880262327698423 +1.6826 0.7049882495383959 0.7049868737899763 -3.5458893320183815e-07 -0.09880298484066308 +1.6827 0.7049888870776232 0.7049875180286633 -3.556141331823026e-07 -0.09880334629582022 +1.6828 0.7049895244138076 0.7049881620845073 -3.5656731582622836e-07 -0.0988037076424878 +1.6829 0.7049901615477803 0.7049888059567919 -3.5744828358330594e-07 -0.09880406888069802 +1.683 0.7049907984803747 0.7049894496447991 -3.582568556120824e-07 -0.09880443001048304 +1.6831 0.704991435212426 0.7049900931478088 -3.589928676828169e-07 -0.098804791031875 +1.6832 0.7049920717447704 0.7049907364650998 -3.59656172274625e-07 -0.09880515194490602 +1.6833000000000002 0.7049927080782457 0.704991379595949 -3.6024663861711215e-07 -0.09880551274960821 +1.6834 0.7049933442136908 0.7049920225396323 -3.6076415260710704e-07 -0.09880587344601371 +1.6835 0.7049939801519464 0.7049926652954248 -3.612086169821338e-07 -0.0988062340341547 +1.6836000000000002 0.7049946158938528 0.7049933078626004 -3.615799512302065e-07 -0.0988065945140632 +1.6837 0.7049952514402515 0.7049939502404323 -3.618780916661568e-07 -0.09880695488577133 +1.6838000000000002 0.7049958867919848 0.7049945924281934 -3.62102991383062e-07 -0.09880731514931113 +1.6839000000000002 0.7049965219498946 0.7049952344251562 -3.622546202869392e-07 -0.09880767530471471 +1.684 0.7049971569148235 0.7049958762305936 -3.6233296513837887e-07 -0.09880803535201416 +1.6841000000000002 0.7049977916876138 0.7049965178437771 -3.6233802947621685e-07 -0.09880839529124148 +1.6842000000000001 0.7049984262691074 0.7049971592639803 -3.6226983366610677e-07 -0.09880875512242876 +1.6843000000000001 0.7049990606601456 0.7049978004904756 -3.621284148450088e-07 -0.098809114845608 +1.6844000000000001 0.7049996948615698 0.7049984415225372 -3.6191382696976193e-07 -0.09880947446081126 +1.6845 0.70500032887422 0.704999082359439 -3.6162614077545063e-07 -0.09880983396807054 +1.6846 0.7050009626989354 0.7049997230004568 -3.61265443699077e-07 -0.09881019336741786 +1.6847 0.7050015963365539 0.7050003634448666 -3.6083183994894963e-07 -0.09881055265888519 +1.6848 0.7050022297879124 0.7050010036919466 -3.603254503659059e-07 -0.09881091184250457 +1.6849 0.705002863053846 0.7050016437409761 -3.5974641250657857e-07 -0.09881127091830792 +1.685 0.7050034961351881 0.7050022835912358 -3.590948805393124e-07 -0.0988116298863273 +1.6851 0.7050041290327702 0.7050029232420086 -3.583710252164085e-07 -0.09881198874659458 +1.6852 0.705004761747422 0.7050035626925792 -3.5757503381861344e-07 -0.09881234749914174 +1.6853000000000002 0.705005394279971 0.7050042019422349 -3.5670711012736334e-07 -0.09881270614400074 +1.6854 0.7050060266312418 0.7050048409902645 -3.557674743762118e-07 -0.09881306468120352 +1.6855 0.7050066588020572 0.7050054798359601 -3.547563631953188e-07 -0.09881342311078196 +1.6856000000000002 0.7050072907932363 0.7050061184786163 -3.5367402949348925e-07 -0.09881378143276803 +1.6857 0.7050079226055963 0.7050067569175305 -3.5252074247899e-07 -0.0988141396471936 +1.6858000000000002 0.7050085542399505 0.7050073951520035 -3.51296787569344e-07 -0.0988144977540906 +1.6859000000000002 0.7050091856971092 0.7050080331813386 -3.5000246627336917e-07 -0.09881485575349089 +1.686 0.7050098169778796 0.7050086710048434 -3.4863809619117836e-07 -0.09881521364542634 +1.6861000000000002 0.7050104480830646 0.7050093086218288 -3.4720401086846264e-07 -0.09881557142992886 +1.6862000000000001 0.7050110790134639 0.705009946031609 -3.457005597548579e-07 -0.0988159291070303 +1.6863000000000001 0.7050117097698729 0.7050105832335026 -3.4412810812761707e-07 -0.0988162866767625 +1.6864000000000001 0.7050123403530834 0.705011220226832 -3.424870369875266e-07 -0.09881664413915732 +1.6865 0.7050129707638819 0.7050118570109241 -3.407777429409453e-07 -0.09881700149424655 +1.6866 0.7050136010030517 0.7050124935851099 -3.390006381165378e-07 -0.09881735874206204 +1.6867 0.7050142310713702 0.7050131299487251 -3.3715615011670197e-07 -0.09881771588263556 +1.6868 0.7050148609696113 0.7050137661011108 -3.352447218857302e-07 -0.09881807291599902 +1.6869 0.7050154906985429 0.7050144020416118 -3.3326681153633686e-07 -0.09881842984218413 +1.687 0.7050161202589287 0.7050150377695791 -3.312228923635363e-07 -0.09881878666122271 +1.6871 0.705016749651526 0.7050156732843682 -3.2911345262953695e-07 -0.0988191433731465 +1.6872 0.7050173788770879 0.7050163085853404 -3.2693899548741356e-07 -0.09881949997798735 +1.6873000000000002 0.705018007936361 0.7050169436718623 -3.247000388700849e-07 -0.09881985647577696 +1.6874 0.7050186368300868 0.7050175785433065 -3.223971153584748e-07 -0.09882021286654712 +1.6875 0.7050192655590002 0.705018213199051 -3.2003077202191754e-07 -0.0988205691503295 +1.6876000000000002 0.7050198941238308 0.7050188476384802 -3.176015703557078e-07 -0.09882092532715589 +1.6877 0.7050205225253013 0.7050194818609846 -3.151100860937506e-07 -0.09882128139705798 +1.6878000000000002 0.7050211507641289 0.7050201158659609 -3.125569090767222e-07 -0.0988216373600675 +1.6879000000000002 0.7050217788410233 0.7050207496528127 -3.099426431688035e-07 -0.09882199321621621 +1.688 0.7050224067566884 0.7050213832209493 -3.0726790602869647e-07 -0.09882234896553568 +1.6881000000000002 0.7050230345118205 0.7050220165697877 -3.0453332903329633e-07 -0.0988227046080577 +1.6882000000000001 0.7050236621071098 0.7050226496987515 -3.017395570903414e-07 -0.0988230601438139 +1.6883000000000001 0.7050242895432386 0.7050232826072713 -2.9888724850310466e-07 -0.09882341557283597 +1.6884000000000001 0.7050249168208829 0.7050239152947848 -2.9597707481773816e-07 -0.0988237708951556 +1.6885 0.7050255439407103 0.7050245477607369 -2.930097206428617e-07 -0.09882412611080431 +1.6886 0.7050261709033816 0.7050251800045806 -2.899858835177238e-07 -0.09882448121981385 +1.6887 0.7050267977095498 0.705025812025776 -2.8690627373872957e-07 -0.09882483622221586 +1.6888 0.7050274243598602 0.7050264438237912 -2.8377161417555974e-07 -0.09882519111804194 +1.6889 0.7050280508549498 0.7050270753981018 -2.8058264012892353e-07 -0.0988255459073237 +1.689 0.7050286771954479 0.7050277067481918 -2.773400991258612e-07 -0.0988259005900927 +1.6891 0.7050293033819756 0.7050283378735531 -2.740447507983135e-07 -0.09882625516638059 +1.6892 0.7050299294151456 0.7050289687736861 -2.706973666402601e-07 -0.09882660963621898 +1.6893000000000002 0.7050305552955622 0.7050295994480993 -2.672987298689422e-07 -0.0988269639996393 +1.6894 0.7050311810238215 0.7050302298963098 -2.6384963524098137e-07 -0.09882731825667329 +1.6895 0.7050318066005101 0.7050308601178437 -2.603508888372741e-07 -0.09882767240735243 +1.6896000000000002 0.7050324320262067 0.7050314901122354 -2.5680330792074435e-07 -0.09882802645170828 +1.6897 0.7050330573014805 0.7050321198790281 -2.532077206796046e-07 -0.09882838038977235 +1.6898000000000002 0.7050336824268919 0.7050327494177746 -2.495649661093946e-07 -0.09882873422157622 +1.6899000000000002 0.7050343074029926 0.7050333787280363 -2.4587589377012e-07 -0.0988290879471514 +1.69 0.7050349322303242 0.7050340078093837 -2.4214136358502447e-07 -0.09882944156652938 +1.6901000000000002 0.7050355569094193 0.7050346366613969 -2.3836224568793418e-07 -0.09882979507974164 +1.6902000000000001 0.7050361814408017 0.7050352652836653 -2.3453942015611018e-07 -0.09883014848681976 +1.6903000000000001 0.7050368058249845 0.7050358936757881 -2.3067377684718449e-07 -0.09883050178779516 +1.6904000000000001 0.705037430062472 0.7050365218373738 -2.2676621519446272e-07 -0.0988308549826993 +1.6905 0.7050380541537584 0.7050371497680408 -2.2281764396406278e-07 -0.09883120807156372 +1.6906 0.705038678099328 0.7050377774674172 -2.18828981084912e-07 -0.09883156105441983 +1.6907 0.705039301899655 0.7050384049351412 -2.148011534058858e-07 -0.09883191393129907 +1.6908 0.705039925555204 0.7050390321708611 -2.1073509649111033e-07 -0.0988322667022329 +1.6909 0.7050405490664293 0.7050396591742347 -2.0663175440138737e-07 -0.09883261936725274 +1.691 0.7050411724337747 0.7050402859449307 -2.0249207947908854e-07 -0.09883297192639001 +1.6911 0.705041795657674 0.7050409124826276 -1.983170321226413e-07 -0.09883332437967612 +1.6912 0.7050424187385504 0.7050415387870148 -1.9410758056101485e-07 -0.0988336767271425 +1.6913000000000002 0.7050430416768168 0.7050421648577916 -1.898647006316756e-07 -0.09883402896882049 +1.6914 0.7050436644728751 0.7050427906946681 -1.8558937557588973e-07 -0.09883438110474152 +1.6915 0.7050442871271174 0.705043416297365 -1.8128259576810635e-07 -0.09883473313493697 +1.6916000000000002 0.7050449096399242 0.7050440416656136 -1.7694535851819904e-07 -0.09883508505943817 +1.6917 0.7050455320116655 0.705044666799156 -1.7257866782166564e-07 -0.0988354368782765 +1.6918000000000002 0.7050461542427011 0.705045291697745 -1.68183534167074e-07 -0.09883578859148331 +1.6919000000000002 0.7050467763333792 0.7050459163611444 -1.6376097425503666e-07 -0.09883614019908998 +1.692 0.7050473982840367 0.7050465407891292 -1.593120107761664e-07 -0.09883649170112774 +1.6921000000000002 0.7050480200950002 0.7050471649814847 -1.54837672192501e-07 -0.09883684309762797 +1.6922000000000001 0.7050486417665851 0.7050477889380081 -1.503389924738252e-07 -0.09883719438862203 +1.6923000000000001 0.7050492632990953 0.705048412658507 -1.4581701088256516e-07 -0.09883754557414111 +1.6924000000000001 0.7050498846928237 0.7050490361428006 -1.4127277172051866e-07 -0.09883789665421658 +1.6925 0.7050505059480516 0.7050496593907196 -1.367073240964023e-07 -0.09883824762887974 +1.6926 0.7050511270650499 0.7050502824021052 -1.3212172167258174e-07 -0.09883859849816187 +1.6927 0.7050517480440769 0.7050509051768103 -1.275170224204758e-07 -0.09883894926209416 +1.6928 0.7050523688853805 0.7050515277146996 -1.228942883985118e-07 -0.09883929992070795 +1.6929 0.7050529895891966 0.7050521500156484 -1.1825458548324341e-07 -0.09883965047403442 +1.693 0.7050536101557499 0.7050527720795439 -1.1359898313169359e-07 -0.09884000092210486 +1.6931 0.7050542305852534 0.7050533939062851 -1.0892855414890157e-07 -0.0988403512649505 +1.6932 0.7050548508779089 0.7050540154957816 -1.0424437441990814e-07 -0.0988407015026025 +1.6933000000000002 0.7050554710339061 0.7050546368479553 -9.954752266255751e-08 -0.09884105163509216 +1.6934 0.7050560910534235 0.7050552579627396 -9.483908020024856e-08 -0.09884140166245063 +1.6935 0.7050567109366277 0.7050558788400794 -9.012013068958324e-08 -0.09884175158470909 +1.6936000000000002 0.7050573306836738 0.7050564994799308 -8.5391759888781e-08 -0.09884210140189874 +1.6937 0.7050579502947056 0.7050571198822622 -8.065505539660289e-08 -0.09884245111405078 +1.6938000000000002 0.7050585697698546 0.7050577400470533 -7.591110640602083e-08 -0.09884280072119639 +1.6939000000000002 0.7050591891092408 0.7050583599742956 -7.116100345701953e-08 -0.0988431502233667 +1.694 0.7050598083129724 0.705058979663992 -6.640583817725532e-08 -0.09884349962059286 +1.6941000000000002 0.7050604273811462 0.7050595991161575 -6.164670304353165e-08 -0.09884384891290598 +1.6942000000000002 0.7050610463138471 0.7050602183308186 -5.688469112115693e-08 -0.09884419810033729 +1.6943000000000001 0.7050616651111481 0.7050608373080134 -5.212089581631274e-08 -0.0988445471829178 +1.6944000000000001 0.7050622837731105 0.7050614560477919 -4.7356410624085216e-08 -0.0988448961606787 +1.6945 0.7050629022997844 0.7050620745502154 -4.2592328878881744e-08 -0.09884524503365104 +1.6946 0.7050635206912075 0.7050626928153575 -3.7829743504305506e-08 -0.09884559380186593 +1.6947 0.7050641389474062 0.7050633108433029 -3.3069746761078475e-08 -0.0988459424653545 +1.6948 0.7050647570683949 0.7050639286341484 -2.831342999507283e-08 -0.09884629102414781 +1.6949 0.7050653750541764 0.7050645461880021 -2.356188339228127e-08 -0.09884663947827688 +1.695 0.705065992904742 0.7050651635049839 -1.8816195722620027e-08 -0.09884698782777278 +1.6951 0.7050666106200713 0.7050657805852256 -1.4077454096091818e-08 -0.0988473360726666 +1.6952 0.705067228200132 0.7050663974288705 -9.346743711034083e-09 -0.0988476842129894 +1.6953000000000003 0.7050678456448805 0.7050670140360731 -4.625147600849366e-09 -0.09884803224877219 +1.6954 0.7050684629542614 0.7050676304069996 8.625360148339922e-11 -0.09884838018004596 +1.6955 0.7050690801282078 0.7050682465418281 4.786381919280602e-09 -0.09884872800684175 +1.6956000000000002 0.7050696971666413 0.7050688624407476 9.474162277617326e-09 -0.09884907572919055 +1.6957 0.7050703140694721 0.705069478103959 1.4148522755295934e-08 -0.09884942334712335 +1.6958000000000002 0.7050709308365987 0.7050700935316747 1.8808394807758033e-08 -0.09884977086067118 +1.6959000000000002 0.7050715474679082 0.7050707087241181 2.3452713543772874e-08 -0.09885011826986498 +1.696 0.7050721639632768 0.7050713236815245 2.8080417945747227e-08 -0.09885046557473576 +1.6961000000000002 0.7050727803225687 0.7050719384041398 3.269045111171931e-08 -0.09885081277531446 +1.6962000000000002 0.705073396545637 0.7050725528922215 3.728176051556731e-08 -0.098851159871632 +1.6963000000000001 0.705074012632324 0.7050731671460384 4.1853298221247726e-08 -0.09885150686371932 +1.6964000000000001 0.7050746285824605 0.7050737811658704 4.640402114647335e-08 -0.09885185375160743 +1.6965 0.705075244395866 0.7050743949520084 5.093289127781897e-08 -0.0988522005353272 +1.6966 0.7050758600723492 0.7050750085047541 5.543887593092989e-08 -0.09885254721490953 +1.6967 0.7050764756117077 0.705075621824421 5.992094796909708e-08 -0.09885289379038537 +1.6968 0.7050770910137281 0.7050762349113326 6.437808604091433e-08 -0.09885324026178562 +1.6969 0.7050777062781863 0.7050768477658238 6.880927481967003e-08 -0.09885358662914114 +1.697 0.705078321404847 0.7050774603882398 7.321350522192238e-08 -0.09885393289248279 +1.6971 0.7050789363934646 0.7050780727789372 7.758977465209538e-08 -0.09885427905184148 +1.6972 0.7050795512437824 0.7050786849382829 8.193708721411508e-08 -0.09885462510724807 +1.6973000000000003 0.7050801659555335 0.7050792968666539 8.625445395080145e-08 -0.09885497105873338 +1.6974 0.7050807805284403 0.7050799085644387 9.054089306764768e-08 -0.09885531690632832 +1.6975 0.7050813949622148 0.7050805200320354 9.47954301618037e-08 -0.09885566265006368 +1.6976000000000002 0.7050820092565584 0.7050811312698526 9.901709841636519e-08 -0.09885600828997028 +1.6977 0.7050826234111625 0.7050817422783091 1.0320493884496962e-07 -0.09885635382607894 +1.6978000000000002 0.7050832374257081 0.7050823530578343 1.0735800051037137e-07 -0.09885669925842046 +1.6979000000000002 0.7050838512998663 0.7050829636088671 1.1147534071179188e-07 -0.09885704458702566 +1.698 0.7050844650332979 0.7050835739318568 1.155560252520671e-07 -0.09885738981192528 +1.6981000000000002 0.7050850786256546 0.7050841840272624 1.1959912860765032e-07 -0.09885773493315021 +1.6982000000000002 0.7050856920765773 0.7050847938955527 1.236037341333096e-07 -0.09885807995073118 +1.6983000000000001 0.7050863053856975 0.7050854035372061 1.2756893429111127e-07 -0.09885842486469888 +1.6984000000000001 0.7050869185526369 0.7050860129527107 1.3149383085164779e-07 -0.09885876967508413 +1.6985 0.7050875315770083 0.705086622142564 1.3537753510220463e-07 -0.09885911438191766 +1.6986 0.7050881444584145 0.7050872311072733 1.3921916804451873e-07 -0.09885945898523023 +1.6987 0.7050887571964491 0.7050878398473547 1.4301786057865917e-07 -0.09885980348505255 +1.6988 0.7050893697906968 0.7050884483633334 1.4677275372160237e-07 -0.09886014788141534 +1.6989 0.7050899822407328 0.7050890566557443 1.5048299877029603e-07 -0.09886049217434933 +1.699 0.7050905945461233 0.7050896647251305 1.5414775754105103e-07 -0.0988608363638852 +1.6991 0.7050912067064261 0.7050902725720443 1.577662025013804e-07 -0.09886118045005363 +1.6992 0.7050918187211896 0.7050908801970466 1.6133751702326893e-07 -0.0988615244328853 +1.6993000000000003 0.7050924305899545 0.7050914876007068 1.648608955046038e-07 -0.09886186831241088 +1.6994 0.7050930423122521 0.7050920947836037 1.6833554359815817e-07 -0.09886221208866111 +1.6995 0.7050936538876056 0.7050927017463231 1.7176067834689945e-07 -0.09886255576166658 +1.6996000000000002 0.7050942653155302 0.70509330848946 1.7513552840256463e-07 -0.09886289933145798 +1.6997 0.7050948765955325 0.7050939150136166 1.7845933418178528e-07 -0.09886324279806591 +1.6998000000000002 0.7050954877271114 0.7050945213194042 1.8173134802915158e-07 -0.09886358616152102 +1.6999000000000002 0.7050960987097579 0.7050951274074411 1.8495083438374582e-07 -0.09886392942185389 +1.7 0.7050967095429552 0.7050957332783534 1.8811706995608413e-07 -0.09886427257909519 +1.7001000000000002 0.7050973202261789 0.7050963389327753 1.9122934388424162e-07 -0.0988646156332755 +1.7002000000000002 0.7050979307588974 0.7050969443713482 1.9428695792814143e-07 -0.09886495858442548 +1.7003000000000001 0.705098541140571 0.7050975495947203 1.9728922655976033e-07 -0.09886530143257562 +1.7004000000000001 0.7050991513706535 0.7050981546035477 2.002354771400705e-07 -0.09886564417775652 +1.7005 0.7050997614485912 0.7050987593984928 2.031250501133286e-07 -0.09886598681999875 +1.7006000000000001 0.7051003713738242 0.7050993639802257 2.0595729911462857e-07 -0.09886632935933289 +1.7007 0.7051009811457849 0.705099968349423 2.0873159109133232e-07 -0.09886667179578949 +1.7008 0.7051015907638996 0.7051005725067674 2.11447306514706e-07 -0.0988670141293991 +1.7009 0.705102200227588 0.7051011764529485 2.1410383946318667e-07 -0.09886735636019223 +1.701 0.7051028095362633 0.7051017801886621 2.1670059776116024e-07 -0.09886769848819939 +1.7011 0.7051034186893328 0.7051023837146102 2.1923700314202543e-07 -0.09886804051345112 +1.7012 0.7051040276861975 0.7051029870315009 2.2171249131758275e-07 -0.09886838243597794 +1.7013000000000003 0.7051046365262529 0.7051035901400478 2.241265122174263e-07 -0.09886872425581028 +1.7014 0.7051052452088881 0.7051041930409705 2.2647852997159656e-07 -0.09886906597297866 +1.7015 0.7051058537334874 0.7051047957349943 2.2876802310139999e-07 -0.09886940758751363 +1.7016000000000002 0.7051064620994294 0.7051053982228497 2.3099448465124794e-07 -0.09886974909944561 +1.7017 0.7051070703060869 0.7051060005052721 2.331574222511068e-07 -0.09887009050880505 +1.7018000000000002 0.7051076783528281 0.7051066025830026 2.3525635829690916e-07 -0.09887043181562241 +1.7019000000000002 0.7051082862390161 0.7051072044567869 2.3729082993667605e-07 -0.09887077301992814 +1.702 0.7051088939640097 0.7051078061273754 2.3926038930643934e-07 -0.0988711141217527 +1.7021000000000002 0.7051095015271622 0.7051084075955231 2.411646035510584e-07 -0.09887145512112648 +1.7022 0.7051101089278229 0.7051090088619898 2.4300305493524244e-07 -0.09887179601807988 +1.7023000000000001 0.7051107161653369 0.7051096099275391 2.4477534095457276e-07 -0.0988721368126434 +1.7024000000000001 0.7051113232390449 0.705110210792939 2.464810743563195e-07 -0.09887247750484736 +1.7025 0.7051119301482838 0.7051108114589614 2.48119883305975e-07 -0.09887281809472216 +1.7026000000000001 0.7051125368923865 0.7051114119263818 2.4969141145664286e-07 -0.09887315858229821 +1.7027 0.7051131434706824 0.7051120121959795 2.511953179490378e-07 -0.09887349896760585 +1.7028 0.7051137498824975 0.7051126122685369 2.5263127759883597e-07 -0.09887383925067544 +1.7029 0.7051143561271547 0.7051132121448405 2.5399898084810246e-07 -0.09887417943153738 +1.703 0.705114962203973 0.705113811825679 2.5529813395958056e-07 -0.09887451951022198 +1.7031 0.7051155681122689 0.7051144113118445 2.565284589473027e-07 -0.09887485948675961 +1.7032 0.705116173851356 0.7051150106041318 2.576896937223072e-07 -0.09887519936118055 +1.7033000000000003 0.7051167794205457 0.7051156097033384 2.5878159216202734e-07 -0.09887553913351518 +1.7034 0.7051173848191465 0.705116208610264 2.598039240894745e-07 -0.0988758788037938 +1.7035 0.7051179900464648 0.7051168073257109 2.6075647536344393e-07 -0.09887621837204674 +1.7036000000000002 0.7051185951018047 0.7051174058504831 2.6163904792014803e-07 -0.09887655783830428 +1.7037 0.7051191999844684 0.7051180041853864 2.6245145980791085e-07 -0.09887689720259663 +1.7038000000000002 0.7051198046937561 0.7051186023312286 2.6319354521492366e-07 -0.09887723646495411 +1.7039000000000002 0.7051204092289671 0.7051192002888194 2.6386515460108395e-07 -0.09887757562540699 +1.704 0.7051210135893988 0.7051197980589694 2.6446615451064526e-07 -0.09887791468398559 +1.7041000000000002 0.7051216177743473 0.7051203956424907 2.6499642782895627e-07 -0.0988782536407201 +1.7042 0.7051222217831077 0.705120993040196 2.6545587365062184e-07 -0.09887859249564075 +1.7043000000000001 0.7051228256149744 0.7051215902528996 2.658444073766475e-07 -0.09887893124877783 +1.7044000000000001 0.705123429269241 0.7051221872814155 2.6616196070750053e-07 -0.09887926990016152 +1.7045 0.7051240327452004 0.7051227841265594 2.6640848163617115e-07 -0.09887960844982206 +1.7046000000000001 0.7051246360421448 0.7051233807891462 2.6658393450368356e-07 -0.09887994689778962 +1.7047 0.7051252391593672 0.7051239772699918 2.6668829988807374e-07 -0.09888028524409444 +1.7048 0.7051258420961597 0.7051245735699114 2.667215748403118e-07 -0.09888062348876667 +1.7049 0.7051264448518149 0.7051251696897209 2.666837725581739e-07 -0.09888096163183654 +1.705 0.7051270474256256 0.7051257656302352 2.6657492262910365e-07 -0.09888129967333421 +1.7051 0.705127649816885 0.7051263613922686 2.663950709261287e-07 -0.09888163761328979 +1.7052 0.7051282520248875 0.7051269569766352 2.6614427961479947e-07 -0.09888197545173352 +1.7053000000000003 0.7051288540489276 0.7051275523841478 2.6582262709073934e-07 -0.09888231318869549 +1.7054 0.7051294558883013 0.7051281476156184 2.6543020800046113e-07 -0.09888265082420587 +1.7055 0.7051300575423057 0.7051287426718573 2.6496713322748944e-07 -0.09888298835829473 +1.7056000000000002 0.7051306590102393 0.705129337553674 2.6443352978133827e-07 -0.09888332579099222 +1.7057 0.7051312602914022 0.7051299322618763 2.638295408738389e-07 -0.09888366312232849 +1.7058000000000002 0.7051318613850959 0.70513052679727 2.631553258289343e-07 -0.09888400035233358 +1.7059000000000002 0.7051324622906238 0.705131121160659 2.624110599785956e-07 -0.09888433748103762 +1.706 0.7051330630072921 0.7051317153528455 2.6159693472527223e-07 -0.0988846745084707 +1.7061000000000002 0.7051336635344084 0.7051323093746289 2.6071315744474743e-07 -0.0988850114346629 +1.7062 0.705134263871283 0.7051329032268066 2.59759951430627e-07 -0.09888534825964425 +1.7063000000000001 0.7051348640172289 0.7051334969101732 2.587375558249505e-07 -0.0988856849834449 +1.7064000000000001 0.7051354639715612 0.7051340904255206 2.5764622560431327e-07 -0.09888602160609472 +1.7065 0.7051360637335988 0.7051346837736373 2.564862315035388e-07 -0.09888635812762389 +1.7066000000000001 0.7051366633026634 0.7051352769553094 2.5525785989077843e-07 -0.0988866945480624 +1.7067 0.7051372626780796 0.7051358699713198 2.539614127605727e-07 -0.09888703086744033 +1.7068 0.7051378618591757 0.7051364628224472 2.5259720765752336e-07 -0.09888736708578762 +1.7069 0.7051384608452835 0.7051370555094673 2.5116557754445434e-07 -0.09888770320313434 +1.707 0.7051390596357385 0.7051376480331515 2.496668707885341e-07 -0.09888803921951042 +1.7071 0.7051396582298801 0.7051382403942679 2.4810145106413106e-07 -0.09888837513494587 +1.7072 0.7051402566270517 0.7051388325935799 2.4646969722097456e-07 -0.09888871094947069 +1.7073000000000003 0.7051408548266014 0.7051394246318474 2.447720032078271e-07 -0.09888904666311485 +1.7074 0.705141452827881 0.7051400165098252 2.4300877803778986e-07 -0.09888938227590832 +1.7075 0.7051420506302473 0.7051406082282635 2.411804456078914e-07 -0.09888971778788104 +1.7076000000000002 0.7051426482330618 0.7051411997879085 2.3928744462969886e-07 -0.09889005319906298 +1.7077 0.7051432456356905 0.7051417911895004 2.3733022854605101e-07 -0.09889038850948403 +1.7078000000000002 0.7051438428375048 0.7051423824337754 2.353092653784028e-07 -0.09889072371917414 +1.7079000000000002 0.705144439837881 0.705142973521464 2.332250376574363e-07 -0.09889105882816326 +1.708 0.7051450366362009 0.7051435644532914 2.31078042339794e-07 -0.09889139383648127 +1.7081000000000002 0.7051456332318518 0.7051441552299769 2.288687905513398e-07 -0.09889172874415803 +1.7082 0.7051462296242268 0.705144745852235 2.2659780760103665e-07 -0.09889206355122354 +1.7083000000000002 0.7051468258127241 0.7051453363207736 2.2426563278665768e-07 -0.09889239825770758 +1.7084000000000001 0.7051474217967486 0.7051459266362949 2.2187281932539715e-07 -0.09889273286364009 +1.7085 0.7051480175757108 0.7051465167994955 2.194199341665204e-07 -0.0988930673690509 +1.7086000000000001 0.7051486131490279 0.7051471068110646 2.1690755790809702e-07 -0.09889340177396992 +1.7087 0.7051492085161228 0.7051476966716862 2.143362845853647e-07 -0.09889373607842696 +1.7088 0.7051498036764253 0.705148286382037 2.1170672162562632e-07 -0.09889407028245184 +1.7089 0.7051503986293721 0.7051488759427872 2.090194895880415e-07 -0.09889440438607443 +1.709 0.705150993374406 0.7051494653546004 2.062752221636266e-07 -0.09889473838932453 +1.7091 0.7051515879109775 0.7051500546181331 2.0347456588382107e-07 -0.098895072292232 +1.7092 0.7051521822385438 0.7051506437340342 2.0061818007885424e-07 -0.09889540609482661 +1.7093000000000003 0.705152776356569 0.7051512327029464 1.9770673663835336e-07 -0.09889573979713817 +1.7094 0.7051533702645253 0.705151821525504 1.947409198933825e-07 -0.09889607339919643 +1.7095 0.7051539639618917 0.7051524102023345 1.9172142649501178e-07 -0.09889640690103123 +1.7096000000000002 0.7051545574481548 0.7051529987340577 1.886489651610479e-07 -0.0988967403026723 +1.7097 0.7051551507228095 0.7051535871212851 1.855242565788895e-07 -0.09889707360414944 +1.7098000000000002 0.705155743785358 0.7051541753646209 1.823480332077687e-07 -0.09889740680549237 +1.7099000000000002 0.7051563366353105 0.7051547634646611 1.7912103914691224e-07 -0.09889773990673084 +1.71 0.7051569292721855 0.7051553514219937 1.7584402986839387e-07 -0.0988980729078946 +1.7101000000000002 0.7051575216955099 0.7051559392371983 1.725177721373372e-07 -0.09889840580901339 +1.7102 0.7051581139048186 0.705156526910846 1.6914304381762668e-07 -0.09889873861011694 +1.7103000000000002 0.7051587058996551 0.7051571144434996 1.6572063363251566e-07 -0.09889907131123493 +1.7104000000000001 0.7051592976795711 0.7051577018357135 1.622513410189097e-07 -0.09889940391239704 +1.7105 0.7051598892441278 0.7051582890880328 1.587359759747109e-07 -0.09889973641363302 +1.7106000000000001 0.7051604805928939 0.7051588762009945 1.5517535880207878e-07 -0.09890006881497249 +1.7107 0.7051610717254484 0.7051594631751262 1.5157031993742742e-07 -0.09890040111644519 +1.7108 0.7051616626413788 0.7051600500109465 1.4792169981958647e-07 -0.09890073331808077 +1.7109 0.7051622533402812 0.7051606367089651 1.4423034859489814e-07 -0.09890106541990887 +1.711 0.7051628438217614 0.7051612232696822 1.4049712599231712e-07 -0.09890139742195919 +1.7111 0.7051634340854344 0.705161809693589 1.3672290109095764e-07 -0.09890172932426129 +1.7112 0.7051640241309245 0.7051623959811668 1.3290855212580444e-07 -0.0989020611268449 +1.7113000000000003 0.705164613957866 0.705162982132888 1.2905496626566815e-07 -0.09890239282973962 +1.7114 0.7051652035659022 0.7051635681492145 1.2516303946746854e-07 -0.09890272443297504 +1.7115 0.7051657929546862 0.7051641540305991 1.212336761882704e-07 -0.09890305593658077 +1.7116000000000002 0.7051663821238812 0.705164739777485 1.172677892083418e-07 -0.09890338734058647 +1.7117 0.7051669710731596 0.7051653253903046 1.1326629946808997e-07 -0.09890371864502165 +1.7118000000000002 0.7051675598022046 0.7051659108694812 1.0923013576275009e-07 -0.0989040498499159 +1.7119000000000002 0.7051681483107088 0.7051664962154275 1.0516023458626012e-07 -0.09890438095529883 +1.712 0.7051687365983753 0.7051670814285464 1.0105753991615507e-07 -0.09890471196119996 +1.7121000000000002 0.705169324664917 0.7051676665092308 9.692300296723633e-08 -0.0989050428676489 +1.7122 0.7051699125100572 0.7051682514578625 9.275758197646589e-08 -0.09890537367467517 +1.7123000000000002 0.7051705001335298 0.7051688362748136 8.856224200173846e-08 -0.09890570438230831 +1.7124000000000001 0.705171087535079 0.7051694209604454 8.433795468248961e-08 -0.09890603499057783 +1.7125 0.705171674714459 0.7051700055151093 8.008569800897758e-08 -0.09890636549951332 +1.7126000000000001 0.7051722616714352 0.7051705899391453 7.58064561141164e-08 -0.09890669590914423 +1.7127000000000001 0.7051728484057832 0.7051711742328832 7.150121902887996e-08 -0.09890702621950008 +1.7128 0.7051734349172896 0.7051717583966426 6.717098247413511e-08 -0.09890735643061042 +1.7129 0.7051740212057513 0.705172342430731 6.281674759349432e-08 -0.09890768654250466 +1.713 0.705174607270976 0.7051729263354464 5.8439520772904374e-08 -0.09890801655521231 +1.7131 0.705175193112783 0.7051735101110752 5.4040313352682334e-08 -0.09890834646876284 +1.7132 0.7051757787310011 0.7051740937578937 4.9620141440165355e-08 -0.09890867628318575 +1.7133000000000003 0.7051763641254714 0.7051746772761665 4.5180025658175804e-08 -0.09890900599851046 +1.7134 0.7051769492960451 0.7051752606661468 4.072099088134329e-08 -0.09890933561476639 +1.7135 0.7051775342425848 0.7051758439280776 3.624406606436703e-08 -0.09890966513198302 +1.7136000000000002 0.705178118964964 0.7051764270621912 3.175028394364343e-08 -0.09890999455018976 +1.7137 0.7051787034630672 0.7051770100687074 2.7240680827364527e-08 -0.09891032386941602 +1.7138000000000002 0.70517928773679 0.705177592947836 2.2716296350921983e-08 -0.0989106530896912 +1.7139000000000002 0.7051798717860398 0.7051781756997753 1.8178173239249973e-08 -0.09891098221104477 +1.714 0.7051804556107345 0.7051787583247119 1.3627357064831258e-08 -0.09891131123350609 +1.7141000000000002 0.7051810392108032 0.7051793408228215 9.06489600049909e-09 -0.09891164015710449 +1.7142 0.7051816225861868 0.705179923194269 4.491840591321072e-09 -0.09891196898186942 +1.7143000000000002 0.7051822057368371 0.7051805054392071 -9.075649173156952e-11 -0.09891229770783022 +1.7144000000000001 0.7051827886627171 0.7051810875577776 -4.681840699849449e-09 -0.09891262633501623 +1.7145 0.7051833713638015 0.7051816695501114 -9.280355844042132e-09 -0.09891295486345683 +1.7146000000000001 0.7051839538400756 0.7051822514163273 -1.3885244338866787e-08 -0.09891328329318134 +1.7147000000000001 0.705184536091537 0.7051828331565333 -1.849544744572315e-08 -0.09891361162421919 +1.7148 0.7051851181181936 0.7051834147708258 -2.310990551701586e-08 -0.09891393985659958 +1.7149 0.7051856999200654 0.7051839962592897 -2.7727558237714695e-08 -0.09891426799035187 +1.715 0.7051862814971834 0.7051845776219987 -3.234734487211899e-08 -0.09891459602550536 +1.7151 0.7051868628495904 0.7051851588590152 -3.696820450108107e-08 -0.09891492396208935 +1.7152 0.7051874439773398 0.70518573997039 -4.15890762769564e-08 -0.09891525180013318 +1.7153000000000003 0.7051880248804971 0.7051863209561626 -4.620889965310207e-08 -0.09891557953966611 +1.7154 0.7051886055591386 0.7051869018163613 -5.0826614637553e-08 -0.0989159071807174 +1.7155 0.7051891860133521 0.7051874825510027 -5.5441162032142735e-08 -0.09891623472331629 +1.7156000000000002 0.7051897662432369 0.7051880631600924 -6.00514836741721e-08 -0.09891656216749209 +1.7157 0.7051903462489033 0.7051886436436242 -6.465652268358019e-08 -0.09891688951327401 +1.7158000000000002 0.7051909260304733 0.7051892240015811 -6.92552237016586e-08 -0.09891721676069132 +1.7159 0.7051915055880795 0.7051898042339347 -7.384653312935904e-08 -0.09891754390977324 +1.716 0.7051920849218667 0.705190384340645 -7.842939937861143e-08 -0.09891787096054899 +1.7161000000000002 0.7051926640319901 0.705190964321661 -8.300277310174103e-08 -0.09891819791304779 +1.7162 0.7051932429186163 0.7051915441769203 -8.756560744387076e-08 -0.09891852476729886 +1.7163000000000002 0.7051938215819232 0.7051921239063498 -9.21168582688689e-08 -0.0989188515233314 +1.7164000000000001 0.7051944000221 0.7051927035098644 -9.665548440524613e-08 -0.09891917818117457 +1.7165 0.7051949782393465 0.7051932829873686 -1.011804478881495e-07 -0.09891950474085756 +1.7166000000000001 0.7051955562338741 0.7051938623387553 -1.0569071419615217e-07 -0.09891983120240955 +1.7167000000000001 0.7051961340059048 0.7051944415639066 -1.101852524724306e-07 -0.0989201575658597 +1.7168 0.7051967115556719 0.7051950206626936 -1.1466303578670789e-07 -0.09892048383123714 +1.7169 0.7051972888834195 0.7051955996349766 -1.1912304133734897e-07 -0.09892080999857107 +1.717 0.7051978659894025 0.7051961784806045 -1.2356425071503863e-07 -0.09892113606789062 +1.7171 0.7051984428738867 0.7051967571994155 -1.2798565012656082e-07 -0.09892146203922488 +1.7172 0.7051990195371489 0.7051973357912377 -1.3238623060470023e-07 -0.09892178791260305 +1.7173000000000003 0.7051995959794762 0.7051979142558872 -1.3676498828232853e-07 -0.09892211368805416 +1.7174 0.705200172201167 0.70519849259317 -1.4112092455720315e-07 -0.09892243936560736 +1.7175 0.7052007482025295 0.7051990708028818 -1.4545304640421752e-07 -0.09892276494529172 +1.7176000000000002 0.7052013239838832 0.7051996488848071 -1.4976036651938307e-07 -0.09892309042713633 +1.7177 0.705201899545558 0.7052002268387205 -1.54041903597385e-07 -0.09892341581117035 +1.7178000000000002 0.7052024748878936 0.7052008046643855 -1.582966825276061e-07 -0.09892374109742276 +1.7179 0.7052030500112405 0.7052013823615557 -1.6252373463525316e-07 -0.09892406628592265 +1.718 0.7052036249159594 0.705201959929974 -1.667220978912587e-07 -0.09892439137669908 +1.7181000000000002 0.7052041996024216 0.7052025373693735 -1.708908171343254e-07 -0.09892471636978108 +1.7182 0.7052047740710079 0.7052031146794766 -1.75028944286032e-07 -0.09892504126519769 +1.7183000000000002 0.7052053483221097 0.705203691859996 -1.7913553855899988e-07 -0.09892536606297797 +1.7184000000000001 0.7052059223561277 0.7052042689106347 -1.832096667014893e-07 -0.0989256907631509 +1.7185 0.7052064961734732 0.705204845831085 -1.872504031413813e-07 -0.09892601536574552 +1.7186000000000001 0.705207069774567 0.7052054226210298 -1.912568303140405e-07 -0.09892633987079084 +1.7187000000000001 0.7052076431598397 0.7052059992801423 -1.9522803873170402e-07 -0.09892666427831583 +1.7188 0.7052082163297313 0.7052065758080859 -1.9916312728532337e-07 -0.0989269885883495 +1.7189 0.7052087892846914 0.7052071522045145 -2.0306120342150624e-07 -0.09892731280092076 +1.719 0.7052093620251794 0.7052077284690723 -2.069213833263972e-07 -0.09892763691605867 +1.7191 0.7052099345516636 0.7052083046013948 -2.1074279218241676e-07 -0.09892796093379216 +1.7192 0.7052105068646219 0.7052088806011076 -2.1452456427928368e-07 -0.09892828485415023 +1.7193000000000003 0.705211078964541 0.7052094564678271 -2.1826584328810128e-07 -0.09892860867716173 +1.7194 0.7052116508519168 0.7052100322011607 -2.2196578242442144e-07 -0.09892893240285562 +1.7195 0.7052122225272544 0.7052106078007074 -2.2562354461130862e-07 -0.09892925603126088 +1.7196000000000002 0.7052127939910671 0.7052111832660566 -2.2923830275342616e-07 -0.09892957956240642 +1.7197 0.7052133652438777 0.7052117585967892 -2.3280923980295576e-07 -0.09892990299632112 +1.7198000000000002 0.7052139362862169 0.7052123337924776 -2.3633554905796994e-07 -0.0989302263330339 +1.7199 0.7052145071186244 0.7052129088526853 -2.3981643429080157e-07 -0.09893054957257365 +1.72 0.7052150777416482 0.7052134837769681 -2.4325110990069954e-07 -0.09893087271496927 +1.7201000000000002 0.7052156481558445 0.7052140585648724 -2.466388011705678e-07 -0.09893119576024961 +1.7202 0.7052162183617773 0.7052146332159377 -2.4997874435023215e-07 -0.09893151870844358 +1.7203000000000002 0.7052167883600191 0.7052152077296943 -2.5327018689583203e-07 -0.09893184155957999 +1.7204000000000002 0.7052173581511502 0.7052157821056653 -2.565123876224762e-07 -0.0989321643136877 +1.7205 0.7052179277357589 0.7052163563433655 -2.5970461683955115e-07 -0.09893248697079558 +1.7206000000000001 0.7052184971144405 0.7052169304423026 -2.628461565831741e-07 -0.09893280953093248 +1.7207000000000001 0.7052190662877986 0.7052175044019762 -2.659363006890514e-07 -0.09893313199412723 +1.7208 0.7052196352564437 0.7052180782218784 -2.689743550249313e-07 -0.09893345436040858 +1.7209 0.7052202040209938 0.7052186519014946 -2.7195963762244313e-07 -0.0989337766298054 +1.721 0.7052207725820739 0.7052192254403027 -2.748914787950585e-07 -0.09893409880234649 +1.7211 0.7052213409403161 0.7052197988377729 -2.777692213427885e-07 -0.09893442087806059 +1.7212 0.7052219090963594 0.7052203720933699 -2.8059222068055334e-07 -0.09893474285697658 +1.7213000000000003 0.7052224770508497 0.7052209452065504 -2.8335984495614364e-07 -0.0989350647391232 +1.7214 0.705223044804439 0.7052215181767651 -2.860714752341009e-07 -0.09893538652452917 +1.7215 0.705223612357786 0.705222091003458 -2.887265056102095e-07 -0.09893570821322328 +1.7216000000000002 0.7052241797115557 0.7052226636860667 -2.91324343339866e-07 -0.0989360298052343 +1.7217 0.7052247468664198 0.7052232362240227 -2.938644089733877e-07 -0.09893635130059095 +1.7218000000000002 0.7052253138230553 0.7052238086167516 -2.963461365260156e-07 -0.09893667269932198 +1.7219 0.7052258805821452 0.705224380863673 -2.98768973523017e-07 -0.09893699400145614 +1.722 0.7052264471443785 0.7052249529642003 -3.0113238119744423e-07 -0.09893731520702209 +1.7221000000000002 0.7052270135104499 0.7052255249177417 -3.034358345907484e-07 -0.0989376363160486 +1.7222 0.7052275796810591 0.7052260967237001 -3.056788226291074e-07 -0.09893795732856432 +1.7223000000000002 0.7052281456569113 0.7052266683814725 -3.0786084827955085e-07 -0.09893827824459797 +1.7224000000000002 0.705228711438717 0.7052272398904513 -3.0998142869220757e-07 -0.09893859906417826 +1.7225 0.7052292770271915 0.7052278112500234 -3.120400952003055e-07 -0.09893891978733382 +1.7226000000000001 0.7052298424230548 0.7052283824595714 -3.140363934867052e-07 -0.09893924041409333 +1.7227000000000001 0.7052304076270317 0.7052289535184729 -3.1596988373655543e-07 -0.09893956094448547 +1.7228 0.7052309726398518 0.7052295244261009 -3.1784014065810995e-07 -0.09893988137853887 +1.7229 0.7052315374622489 0.7052300951818238 -3.1964675357987193e-07 -0.09894020171628222 +1.723 0.7052321020949606 0.705230665785006 -3.2138932656855523e-07 -0.0989405219577441 +1.7231 0.705232666538729 0.7052312362350082 -3.2306747852622886e-07 -0.09894084210295313 +1.7232 0.7052332307943001 0.7052318065311864 -3.2468084323888924e-07 -0.09894116215193799 +1.7233000000000003 0.7052337948624234 0.7052323766728936 -3.262290694458492e-07 -0.09894148210472725 +1.7234 0.7052343587438521 0.7052329466594786 -3.277118210062713e-07 -0.09894180196134955 +1.7235 0.7052349224393428 0.705233516490287 -3.291287768436568e-07 -0.0989421217218334 +1.7236000000000002 0.705235485949655 0.7052340861646614 -3.3047963108462364e-07 -0.09894244138620747 +1.7237 0.7052360492755518 0.7052346556819409 -3.317640931699284e-07 -0.09894276095450028 +1.7238000000000002 0.7052366124177993 0.7052352250414617 -3.329818878197721e-07 -0.09894308042674047 +1.7239 0.7052371753771656 0.7052357942425573 -3.3413275516563923e-07 -0.09894339980295647 +1.724 0.7052377381544219 0.7052363632845593 -3.352164507225419e-07 -0.09894371908317698 +1.7241000000000002 0.7052383007503419 0.7052369321667953 -3.3623274559024807e-07 -0.09894403826743048 +1.7242 0.7052388631657014 0.7052375008885918 -3.371814263214423e-07 -0.09894435735574553 +1.7243000000000002 0.7052394254012778 0.705238069449273 -3.3806229509519836e-07 -0.0989446763481506 +1.7244000000000002 0.7052399874578514 0.7052386378481609 -3.3887516971697895e-07 -0.09894499524467423 +1.7245 0.7052405493362035 0.705239206084576 -3.396198836325137e-07 -0.09894531404534498 +1.7246000000000001 0.7052411110371172 0.7052397741578369 -3.402962859971881e-07 -0.0989456327501913 +1.7247000000000001 0.7052416725613772 0.705240342067261 -3.409042416760433e-07 -0.09894595135924172 +1.7248 0.705242233909769 0.7052409098121644 -3.4144363129234856e-07 -0.0989462698725247 +1.7249 0.7052427950830795 0.7052414773918618 -3.4191435126923464e-07 -0.09894658829006872 +1.725 0.7052433560820967 0.7052420448056675 -3.423163137741825e-07 -0.09894690661190227 +1.7251 0.7052439169076086 0.7052426120528945 -3.426494468439234e-07 -0.09894722483805375 +1.7252 0.7052444775604048 0.7052431791328557 -3.429136942803557e-07 -0.09894754296855174 +1.7253000000000003 0.705245038041274 0.7052437460448631 -3.4310901571993346e-07 -0.09894786100342454 +1.7254 0.7052455983510064 0.7052443127882286 -3.432353866822391e-07 -0.09894817894270065 +1.7255 0.7052461584903914 0.7052448793622643 -3.4329279849365513e-07 -0.09894849678640849 +1.7256000000000002 0.7052467184602188 0.705245445766282 -3.4328125829430345e-07 -0.09894881453457649 +1.7257 0.705247278261278 0.7052460119995944 -3.4320078906580065e-07 -0.0989491321872331 +1.7258000000000002 0.7052478378943574 0.7052465780615136 -3.4305142961044144e-07 -0.09894944974440664 +1.7259 0.7052483973602457 0.705247143951353 -3.4283323453732084e-07 -0.09894976720612557 +1.726 0.7052489566597299 0.7052477096684266 -3.425462742415175e-07 -0.09895008457241823 +1.7261000000000002 0.7052495157935967 0.7052482752120495 -3.421906348485826e-07 -0.09895040184331305 +1.7262 0.7052500747626314 0.7052488405815374 -3.4176641823535636e-07 -0.09895071901883831 +1.7263000000000002 0.7052506335676181 0.705249405776208 -3.412737420369072e-07 -0.09895103609902248 +1.7264000000000002 0.7052511922093394 0.7052499707953798 -3.407127395355092e-07 -0.09895135308389387 +1.7265 0.705251750688576 0.7052505356383731 -3.400835596606422e-07 -0.0989516699734808 +1.7266000000000001 0.7052523090061074 0.7052511003045103 -3.3938636694041957e-07 -0.09895198676781164 +1.7267000000000001 0.7052528671627105 0.7052516647931153 -3.386213414738326e-07 -0.09895230346691469 +1.7268000000000001 0.7052534251591607 0.7052522291035139 -3.3778867888217823e-07 -0.09895262007081831 +1.7269 0.7052539829962303 0.7052527932350352 -3.368885902535479e-07 -0.09895293657955082 +1.727 0.7052545406746897 0.7052533571870095 -3.35921302115072e-07 -0.09895325299314045 +1.7271 0.7052550981953066 0.7052539209587706 -3.3488705631495863e-07 -0.09895356931161553 +1.7272 0.7052556555588461 0.7052544845496547 -3.337861100155548e-07 -0.0989538855350044 +1.7273000000000003 0.7052562127660695 0.7052550479590007 -3.326187356308963e-07 -0.09895420166333525 +1.7274 0.7052567698177361 0.705255611186151 -3.3138522070874643e-07 -0.09895451769663643 +1.7275 0.7052573267146012 0.7052561742304511 -3.300858679514129e-07 -0.09895483363493612 +1.7276000000000002 0.7052578834574169 0.7052567370912498 -3.2872099503533647e-07 -0.09895514947826269 +1.7277 0.7052584400469317 0.7052572997678996 -3.272909346180297e-07 -0.09895546522664428 +1.7278000000000002 0.7052589964838905 0.705257862259757 -3.2579603419236047e-07 -0.0989557808801092 +1.7279 0.7052595527690335 0.7052584245661817 -3.2423665605879615e-07 -0.09895609643868566 +1.728 0.7052601089030979 0.7052589866865382 -3.2261317720050364e-07 -0.09895641190240188 +1.7281000000000002 0.7052606648868158 0.7052595486201945 -3.209259892208993e-07 -0.09895672727128606 +1.7282 0.7052612207209155 0.7052601103665235 -3.191754982048711e-07 -0.09895704254536639 +1.7283000000000002 0.7052617764061206 0.7052606719249024 -3.173621246979619e-07 -0.0989573577246711 +1.7284000000000002 0.7052623319431501 0.7052612332947129 -3.154863035120803e-07 -0.09895767280922839 +1.7285 0.7052628873327176 0.7052617944753419 -3.1354848367692867e-07 -0.0989579877990664 +1.7286000000000001 0.7052634425755322 0.705262355466181 -3.115491283359195e-07 -0.09895830269421332 +1.7287000000000001 0.705263997672298 0.705262916266627 -3.094887146073977e-07 -0.09895861749469734 +1.7288000000000001 0.7052645526237133 0.7052634768760817 -3.0736773351525137e-07 -0.09895893220054658 +1.7289 0.7052651074304713 0.7052640372939529 -3.0518668978074537e-07 -0.09895924681178919 +1.729 0.7052656620932594 0.7052645975196534 -3.029461018641544e-07 -0.09895956132845332 +1.7291 0.7052662166127598 0.7052651575526021 -3.006465016733295e-07 -0.09895987575056713 +1.7292 0.7052667709896479 0.7052657173922238 -2.9828843452553433e-07 -0.0989601900781587 +1.7293000000000003 0.705267325224594 0.7052662770379485 -2.958724589739725e-07 -0.09896050431125619 +1.7294 0.7052678793182614 0.7052668364892132 -2.933991467488073e-07 -0.09896081844988763 +1.7295 0.705268433271308 0.7052673957454607 -2.9086908252470844e-07 -0.09896113249408121 +1.7296 0.7052689870843845 0.7052679548061407 -2.88282863879219e-07 -0.09896144644386495 +1.7297 0.7052695407581354 0.7052685136707089 -2.856411010776494e-07 -0.09896176029926702 +1.7298000000000002 0.7052700942931984 0.7052690723386279 -2.8294441696552486e-07 -0.09896207406031539 +1.7299 0.7052706476902042 0.7052696308093671 -2.801934468159295e-07 -0.09896238772703816 +1.73 0.705271200949777 0.7052701890824027 -2.773888381872591e-07 -0.09896270129946338 +1.7301000000000002 0.7052717540725335 0.7052707471572184 -2.7453125074280993e-07 -0.09896301477761915 +1.7302 0.7052723070590834 0.7052713050333047 -2.7162135613281735e-07 -0.09896332816153351 +1.7303000000000002 0.7052728599100287 0.7052718627101597 -2.6865983780363645e-07 -0.09896364145123449 +1.7304000000000002 0.7052734126259643 0.7052724201872885 -2.6564739084508626e-07 -0.09896395464675006 +1.7305 0.7052739652074773 0.7052729774642041 -2.625847218586108e-07 -0.09896426774810824 +1.7306000000000001 0.705274517655147 0.7052735345404275 -2.594725487491123e-07 -0.09896458075533712 +1.7307000000000001 0.7052750699695449 0.705274091415487 -2.5631160060352043e-07 -0.09896489366846462 +1.7308000000000001 0.7052756221512348 0.7052746480889189 -2.531026174444617e-07 -0.09896520648751878 +1.7309 0.705276174200772 0.7052752045602677 -2.498463501435233e-07 -0.09896551921252753 +1.731 0.7052767261187044 0.7052757608290859 -2.465435601818611e-07 -0.09896583184351891 +1.7311 0.7052772779055704 0.7052763168949346 -2.4319501953223854e-07 -0.09896614438052084 +1.7312 0.7052778295619011 0.705276872757383 -2.3980151041963493e-07 -0.09896645682356134 +1.7313000000000003 0.705278381088218 0.7052774284160087 -2.363638251651201e-07 -0.09896676917266826 +1.7314 0.7052789324850353 0.7052779838703984 -2.32882765995035e-07 -0.09896708142786968 +1.7315 0.7052794837528571 0.7052785391201467 -2.2935914488139697e-07 -0.09896739358919339 +1.7316 0.70528003489218 0.7052790941648579 -2.2579378329903865e-07 -0.09896770565666746 +1.7317 0.7052805859034903 0.7052796490041445 -2.2218751208682996e-07 -0.09896801763031968 +1.7318000000000002 0.7052811367872664 0.7052802036376284 -2.1854117120481686e-07 -0.09896832951017806 +1.7319 0.705281687543977 0.7052807580649403 -2.1485560959544348e-07 -0.09896864129627042 +1.732 0.7052822381740818 0.7052813122857204 -2.1113168494416024e-07 -0.09896895298862474 +1.7321000000000002 0.7052827886780311 0.7052818662996179 -2.0737026349554322e-07 -0.09896926458726889 +1.7322 0.7052833390562656 0.7052824201062917 -2.0357221982778007e-07 -0.0989695760922307 +1.7323000000000002 0.705283889309217 0.7052829737054098 -1.9973843670695324e-07 -0.09896988750353808 +1.7324000000000002 0.705284439437307 0.7052835270966498 -1.958698048060148e-07 -0.09897019882121885 +1.7325 0.7052849894409479 0.7052840802796989 -1.919672225660085e-07 -0.0989705100453009 +1.7326000000000001 0.7052855393205419 0.7052846332542546 -1.8803159595667807e-07 -0.09897082117581209 +1.7327000000000001 0.705286089076482 0.7052851860200233 -1.8406383825095296e-07 -0.0989711322127802 +1.7328000000000001 0.7052866387091508 0.7052857385767219 -1.800648698306595e-07 -0.09897144315623313 +1.7329 0.7052871882189211 0.7052862909240769 -1.7603561799917067e-07 -0.09897175400619869 +1.733 0.7052877376061558 0.705286843061825 -1.719770167142587e-07 -0.09897206476270469 +1.7331 0.7052882868712074 0.7052873949897127 -1.678900064215616e-07 -0.09897237542577891 +1.7332 0.7052888360144185 0.7052879467074968 -1.6377553377702747e-07 -0.09897268599544914 +1.7333000000000003 0.705289385036121 0.7052884982149444 -1.5963455150293238e-07 -0.0989729964717432 +1.7334 0.7052899339366376 0.7052890495118329 -1.554680180947121e-07 -0.09897330685468889 +1.7335 0.7052904827162796 0.7052896005979499 -1.512768976578982e-07 -0.09897361714431396 +1.7336 0.7052910313753482 0.7052901514730929 -1.4706215964443992e-07 -0.09897392734064618 +1.7337 0.7052915799141339 0.7052907021370708 -1.4282477865147636e-07 -0.09897423744371327 +1.7338000000000002 0.7052921283329172 0.7052912525897024 -1.3856573418367935e-07 -0.09897454745354303 +1.7339 0.7052926766319678 0.705291802830817 -1.3428601043988242e-07 -0.09897485737016319 +1.734 0.7052932248115447 0.7052923528602548 -1.2998659607021956e-07 -0.09897516719360146 +1.7341000000000002 0.705293772871896 0.7052929026778665 -1.2566848396101948e-07 -0.09897547692388559 +1.7342 0.7052943208132598 0.7052934522835134 -1.2133267099194434e-07 -0.0989757865610433 +1.7343000000000002 0.7052948686358629 0.7052940016770675 -1.1698015782261872e-07 -0.09897609610510233 +1.7344000000000002 0.7052954163399213 0.7052945508584114 -1.1261194864629898e-07 -0.09897640555609027 +1.7345 0.7052959639256404 0.705295099827439 -1.0822905096956326e-07 -0.09897671491403487 +1.7346000000000001 0.7052965113932147 0.7052956485840545 -1.0383247537031765e-07 -0.09897702417896385 +1.7347000000000001 0.7052970587428278 0.7052961971281734 -9.942323527835362e-08 -0.09897733335090486 +1.7348000000000001 0.7052976059746525 0.7052967454597217 -9.500234672641522e-08 -0.09897764242988555 +1.7349 0.7052981530888507 0.7052972935786362 -9.057082812641976e-08 -0.09897795141593363 +1.735 0.705298700085573 0.7052978414848653 -8.612970003613746e-08 -0.09897826030907672 +1.7351 0.7052992469649593 0.7052983891783675 -8.167998490852396e-08 -0.09897856910934241 +1.7352 0.7052997937271385 0.7052989366591127 -7.722270687921667e-08 -0.09897887781675843 +1.7353000000000003 0.7053003403722284 0.7052994839270823 -7.275889151586723e-08 -0.0989791864313524 +1.7354 0.705300886900336 0.7053000309822675 -6.828956558568855e-08 -0.09897949495315188 +1.7355 0.7053014333115568 0.7053005778246715 -6.38157568182314e-08 -0.09897980338218454 +1.7356 0.7053019796059761 0.7053011244543078 -5.9338493673798814e-08 -0.09898011171847794 +1.7357 0.7053025257836669 0.7053016708712017 -5.485880510036796e-08 -0.09898041996205972 +1.7358000000000002 0.7053030718446924 0.7053022170753886 -5.037772030677505e-08 -0.09898072811295738 +1.7359 0.7053036177891041 0.7053027630669157 -4.589626851237306e-08 -0.09898103617119863 +1.736 0.7053041636169426 0.7053033088458409 -4.141547872411975e-08 -0.09898134413681096 +1.7361000000000002 0.7053047093282376 0.705303854412233 -3.693637949328272e-08 -0.09898165200982195 +1.7362 0.7053052549230077 0.7053043997661719 -3.245999868092646e-08 -0.0989819597902592 +1.7363000000000002 0.70530580040126 0.7053049449077484 -2.7987363223399425e-08 -0.0989822674781502 +1.7364000000000002 0.7053063457629911 0.7053054898370645 -2.351949889446009e-08 -0.09898257507352244 +1.7365 0.705306891008187 0.705306034554233 -1.9057430072390302e-08 -0.09898288257640359 +1.7366000000000001 0.7053074361368219 0.7053065790593777 -1.4602179503313967e-08 -0.09898318998682107 +1.7367000000000001 0.7053079811488594 0.7053071233526332 -1.0154768068093567e-08 -0.09898349730480244 +1.7368000000000001 0.705308526044252 0.7053076674341452 -5.7162145494435435e-09 -0.09898380453037518 +1.7369 0.7053090708229419 0.7053082113040703 -1.2875353934058142e-09 -0.09898411166356685 +1.737 0.7053096154848598 0.7053087549625754 3.1302555157305956e-09 -0.09898441870440489 +1.7371 0.7053101600299256 0.7053092984098388 7.536147090918266e-09 -0.09898472565291676 +1.7372 0.7053107044580487 0.7053098416460495 1.1929131274804328e-08 -0.09898503250912996 +1.7373000000000003 0.7053112487691274 0.7053103846714072 1.630820327391813e-08 -0.09898533927307196 +1.7374 0.7053117929630498 0.7053109274861221 2.067236177464432e-08 -0.09898564594477027 +1.7375 0.7053123370396925 0.7053114700904153 2.5020609190420928e-08 -0.09898595252425227 +1.7376 0.7053128809989222 0.7053120124845188 2.9351951875977722e-08 -0.09898625901154548 +1.7377 0.7053134248405942 0.7053125546686744 3.366540035805443e-08 -0.09898656540667723 +1.7378000000000002 0.7053139685645542 0.705313096643135 3.795996956351688e-08 -0.09898687170967505 +1.7379 0.7053145121706365 0.7053136384081639 4.223467904226896e-08 -0.09898717792056627 +1.738 0.7053150556586655 0.7053141799640348 4.648855319797085e-08 -0.09898748403937835 +1.7381000000000002 0.705315599028455 0.7053147213110318 5.072062150140999e-08 -0.09898779006613873 +1.7382 0.7053161422798084 0.7053152624494492 5.4929918709076264e-08 -0.09898809600087476 +1.7383000000000002 0.705316685412519 0.7053158033795921 5.911548509214548e-08 -0.09898840184361382 +1.7384000000000002 0.7053172284263693 0.7053163441017748 6.327636664811565e-08 -0.0989887075943833 +1.7385 0.7053177713211327 0.7053168846163225 6.741161533499462e-08 -0.09898901325321058 +1.7386000000000001 0.7053183140965715 0.7053174249235703 7.15202892673239e-08 -0.09898931882012302 +1.7387000000000001 0.7053188567524382 0.7053179650238632 7.560145293301901e-08 -0.09898962429514796 +1.7388000000000001 0.705319399288476 0.7053185049175565 7.965417742235303e-08 -0.09898992967831279 +1.7389000000000001 0.7053199417044175 0.7053190446050148 8.367754061010257e-08 -0.09899023496964487 +1.739 0.7053204839999855 0.7053195840866127 8.76706273966743e-08 -0.09899054016917143 +1.7391 0.7053210261748932 0.7053201233627344 9.163252989025095e-08 -0.09899084527691986 +1.7392 0.7053215682288445 0.7053206624337744 9.556234765312199e-08 -0.09899115029291748 +1.7393000000000003 0.7053221101615332 0.7053212013001359 9.945918785433938e-08 -0.09899145521719159 +1.7394 0.7053226519726439 0.705321739962232 1.0332216550737461e-07 -0.0989917600497695 +1.7395 0.7053231936618518 0.7053222784204847 1.0715040364359107e-07 -0.09899206479067849 +1.7396 0.7053237352288229 0.7053228166753258 1.1094303354469703e-07 -0.09899236943994583 +1.7397 0.7053242766732133 0.7053233547271964 1.1469919491968739e-07 -0.09899267399759881 +1.7398000000000002 0.705324817994671 0.7053238925765462 1.1841803610260215e-07 -0.09899297846366473 +1.7399 0.705325359192834 0.7053244302238342 1.2209871425722385e-07 -0.0989932828381708 +1.74 0.7053259002673323 0.7053249676695277 1.257403955193248e-07 -0.09899358712114427 +1.7401000000000002 0.7053264412177862 0.7053255049141038 1.2934225527422294e-07 -0.09899389131261242 +1.7402 0.705326982043808 0.705326041958048 1.3290347826433457e-07 -0.0989941954126025 +1.7403000000000002 0.7053275227450007 0.7053265788018541 1.3642325881121908e-07 -0.0989944994211417 +1.7404000000000002 0.7053280633209591 0.7053271154460246 1.3990080097517343e-07 -0.09899480333825725 +1.7405 0.7053286037712696 0.70532765189107 1.43335318763399e-07 -0.09899510716397636 +1.7406000000000001 0.7053291440955103 0.70532818813751 1.4672603628612668e-07 -0.09899541089832627 +1.7407000000000001 0.7053296842932508 0.7053287241858714 1.500721879266198e-07 -0.09899571454133411 +1.7408000000000001 0.7053302243640533 0.70532926003669 1.5337301855281038e-07 -0.09899601809302716 +1.7409000000000001 0.7053307643074712 0.7053297956905087 1.5662778362832142e-07 -0.09899632155343252 +1.741 0.7053313041230505 0.7053303311478789 1.598357494483893e-07 -0.09899662492257738 +1.7411 0.7053318438103295 0.7053308664093594 1.6299619323700831e-07 -0.09899692820048898 +1.7412 0.7053323833688386 0.7053314014755165 1.661084033724447e-07 -0.09899723138719435 +1.7413000000000003 0.7053329227981008 0.7053319363469246 1.6917167947050338e-07 -0.09899753448272075 +1.7414 0.7053334620976317 0.7053324710241644 1.72185332641267e-07 -0.09899783748709523 +1.7415 0.70533400126694 0.7053330055078249 1.7514868555848495e-07 -0.09899814040034502 +1.7416 0.7053345403055269 0.7053335397985017 1.7806107265733173e-07 -0.09899844322249723 +1.7417 0.7053350792128863 0.7053340738967969 1.8092184025930713e-07 -0.0989987459535789 +1.7418000000000002 0.7053356179885061 0.7053346078033205 1.8373034673183075e-07 -0.09899904859361723 +1.7419 0.7053361566318666 0.7053351415186881 1.8648596265477546e-07 -0.09899935114263925 +1.742 0.7053366951424418 0.7053356750435229 1.8918807090720358e-07 -0.09899965360067205 +1.7421000000000002 0.7053372335196995 0.7053362083784538 1.9183606683736976e-07 -0.09899995596774278 +1.7422 0.7053377717631006 0.7053367415241163 1.9442935842231557e-07 -0.09900025824387845 +1.7423000000000002 0.7053383098721007 0.7053372744811522 1.969673663511362e-07 -0.09900056042910621 +1.7424000000000002 0.7053388478461483 0.705337807250209 1.9944952417416673e-07 -0.09900086252345303 +1.7425 0.7053393856846868 0.7053383398319406 2.018752784486988e-07 -0.09900116452694607 +1.7426000000000001 0.705339923387153 0.7053388722270061 2.0424408883612521e-07 -0.09900146643961232 +1.7427000000000001 0.7053404609529788 0.7053394044360706 2.0655542823377893e-07 -0.09900176826147881 +1.7428000000000001 0.7053409983815903 0.7053399364598043 2.0880878288595528e-07 -0.09900206999257258 +1.7429000000000001 0.705341535672408 0.7053404682988831 2.1100365251575104e-07 -0.09900237163292062 +1.743 0.7053420728248478 0.7053409999539881 2.1313955038404497e-07 -0.09900267318255003 +1.7431 0.70534260983832 0.7053415314258051 2.1521600347337855e-07 -0.09900297464148776 +1.7432 0.7053431467122303 0.7053420627150253 2.1723255255040597e-07 -0.09900327600976087 +1.7433 0.7053436834459793 0.7053425938223437 2.1918875228038592e-07 -0.09900357728739624 +1.7434 0.7053442200389632 0.705343124748461 2.2108417126187607e-07 -0.09900387847442094 +1.7435 0.7053447564905739 0.7053436554940815 2.2291839225918597e-07 -0.09900417957086192 +1.7436 0.7053452928001988 0.7053441860599143 2.2469101217115206e-07 -0.09900448057674616 +1.7437 0.7053458289672208 0.7053447164466724 2.264016421144044e-07 -0.09900478149210058 +1.7438000000000002 0.7053463649910194 0.7053452466550729 2.2804990761765564e-07 -0.09900508231695217 +1.7439 0.7053469008709701 0.7053457766858364 2.2963544861476226e-07 -0.09900538305132789 +1.744 0.7053474366064443 0.7053463065396877 2.3115791955574672e-07 -0.09900568369525464 +1.7441000000000002 0.7053479721968103 0.7053468362173547 2.3261698948312537e-07 -0.09900598424875934 +1.7442 0.7053485076414329 0.7053473657195688 2.3401234204578625e-07 -0.09900628471186897 +1.7443000000000002 0.7053490429396735 0.7053478950470645 2.3534367570021697e-07 -0.09900658508461035 +1.7444000000000002 0.7053495780908907 0.7053484242005797 2.3661070358560465e-07 -0.09900688536701052 +1.7445 0.7053501130944402 0.7053489531808548 2.3781315380139167e-07 -0.0990071855590963 +1.7446000000000002 0.7053506479496745 0.7053494819886326 2.3895076925462e-07 -0.09900748566089454 +1.7447000000000001 0.705351182655944 0.7053500106246593 2.400233078958536e-07 -0.09900778567243218 +1.7448000000000001 0.7053517172125965 0.7053505390896826 2.41030542677545e-07 -0.09900808559373603 +1.7449000000000001 0.7053522516189774 0.7053510673844535 2.419722615332187e-07 -0.09900838542483303 +1.745 0.7053527858744306 0.705351595509724 2.428482676203325e-07 -0.09900868516575001 +1.7451 0.7053533199782971 0.705352123466249 2.436583791606828e-07 -0.0990089848165138 +1.7452 0.7053538539299169 0.7053526512547842 2.4440242958612135e-07 -0.09900928437715129 +1.7453 0.7053543877286279 0.7053531788760874 2.450802675593722e-07 -0.09900958384768928 +1.7454 0.7053549213737671 0.7053537063309178 2.4569175696709245e-07 -0.0990098832281546 +1.7455 0.7053554548646697 0.7053542336200356 2.462367769962004e-07 -0.09901018251857405 +1.7456 0.7053559882006698 0.7053547607442027 2.4671522211305863e-07 -0.09901048171897449 +1.7457 0.705356521381101 0.705355287704181 2.4712700207735194e-07 -0.09901078082938268 +1.7458000000000002 0.7053570544052957 0.7053558145007339 2.4747204207392626e-07 -0.09901107984982543 +1.7459 0.7053575872725857 0.7053563411346256 2.477502825254385e-07 -0.09901137878032956 +1.746 0.7053581199823025 0.7053568676066199 2.47961679265829e-07 -0.09901167762092178 +1.7461000000000002 0.7053586525337772 0.7053573939174815 2.4810620349868806e-07 -0.09901197637162898 +1.7462 0.7053591849263408 0.7053579200679749 2.4818384178337816e-07 -0.09901227503247784 +1.7463000000000002 0.7053597171593241 0.7053584460588646 2.4819459601421734e-07 -0.0990125736034951 +1.7464000000000002 0.7053602492320588 0.7053589718909148 2.481384834829292e-07 -0.09901287208470756 +1.7465 0.7053607811438758 0.7053594975648897 2.4801553681619293e-07 -0.09901317047614189 +1.7466000000000002 0.7053613128941076 0.7053600230815527 2.4782580396870424e-07 -0.09901346877782491 +1.7467000000000001 0.7053618444820868 0.7053605484416661 2.4756934821623666e-07 -0.09901376698978327 +1.7468000000000001 0.705362375907147 0.7053610736459921 2.4724624816951923e-07 -0.09901406511204373 +1.7469000000000001 0.705362907168623 0.7053615986952912 2.468565976840309e-07 -0.099014363144633 +1.747 0.7053634382658505 0.7053621235903234 2.464005058808172e-07 -0.09901466108757773 +1.7471 0.7053639691981666 0.7053626483318465 2.4587809709791797e-07 -0.09901495894090473 +1.7472 0.7053644999649099 0.7053631729206169 2.4528951084873407e-07 -0.09901525670464056 +1.7473 0.7053650305654211 0.70536369735739 2.4463490189141623e-07 -0.09901555437881197 +1.7474 0.7053655609990419 0.7053642216429189 2.439144399790649e-07 -0.09901585196344564 +1.7475 0.7053660912651167 0.7053647457779544 2.43128310012386e-07 -0.0990161494585682 +1.7476 0.7053666213629919 0.7053652697632455 2.422767119147906e-07 -0.09901644686420633 +1.7477 0.7053671512920158 0.7053657935995388 2.413598605283118e-07 -0.09901674418038663 +1.7478000000000002 0.7053676810515397 0.7053663172875781 2.403779856968713e-07 -0.09901704140713578 +1.7479 0.7053682106409171 0.7053668408281052 2.3933133204423473e-07 -0.09901733854448042 +1.748 0.7053687400595046 0.7053673642218585 2.3822015906421745e-07 -0.09901763559244713 +1.7481000000000002 0.7053692693066616 0.7053678874695737 2.3704474096802874e-07 -0.09901793255106256 +1.7482 0.7053697983817507 0.705368410571983 2.3580536661488294e-07 -0.09901822942035331 +1.7483000000000002 0.7053703272841376 0.7053689335298158 2.345023395050605e-07 -0.09901852620034596 +1.7484000000000002 0.7053708560131917 0.705369456343798 2.3313597764806904e-07 -0.09901882289106716 +1.7485 0.7053713845682854 0.7053699790146515 2.317066134863155e-07 -0.09901911949254344 +1.7486000000000002 0.7053719129487956 0.7053705015430948 2.3021459386735055e-07 -0.09901941600480137 +1.7487000000000001 0.7053724411541027 0.7053710239298425 2.2866027989121296e-07 -0.09901971242786761 +1.7488000000000001 0.7053729691835908 0.7053715461756047 2.2704404688961288e-07 -0.09902000876176863 +1.7489000000000001 0.7053734970366488 0.7053720682810882 2.253662842940929e-07 -0.09902030500653107 +1.749 0.7053740247126694 0.7053725902469944 2.2362739551806676e-07 -0.09902060116218137 +1.7491 0.7053745522110502 0.7053731120740208 2.2182779793600282e-07 -0.09902089722874613 +1.7492 0.7053750795311932 0.7053736337628598 2.1996792270301269e-07 -0.0990211932062519 +1.7493 0.705375606672505 0.7053741553141999 2.180482146924012e-07 -0.09902148909472516 +1.7494 0.7053761336343976 0.7053746767287236 2.1606913245403314e-07 -0.09902178489419243 +1.7495 0.7053766604162875 0.7053751980071089 2.1403114796106348e-07 -0.09902208060468023 +1.7496 0.7053771870175969 0.7053757191500285 2.119347466029986e-07 -0.09902237622621507 +1.7497 0.7053777134377535 0.7053762401581496 2.0978042703651e-07 -0.09902267175882346 +1.7498000000000002 0.7053782396761892 0.705376761032134 2.075687010709426e-07 -0.09902296720253181 +1.7499 0.705378765732343 0.7053772817726376 2.0530009356076184e-07 -0.09902326255736665 +1.75 0.7053792916056596 0.7053778023803106 2.0297514223902025e-07 -0.09902355782335447 +1.7501000000000002 0.7053798172955885 0.7053783228557976 2.0059439766878517e-07 -0.09902385300052169 +1.7502 0.7053803428015863 0.7053788431997368 1.9815842300374698e-07 -0.09902414808889477 +1.7503000000000002 0.7053808681231152 0.7053793634127603 1.956677939604634e-07 -0.09902444308850022 +1.7504000000000002 0.7053813932596438 0.7053798834954937 1.9312309861019283e-07 -0.0990247379993644 +1.7505 0.7053819182106472 0.7053804034485566 1.9052493728174968e-07 -0.09902503282151379 +1.7506000000000002 0.705382442975607 0.7053809232725612 1.8787392240537937e-07 -0.09902532755497473 +1.7507000000000001 0.705382967554012 0.7053814429681139 1.8517067838785817e-07 -0.09902562219977377 +1.7508000000000001 0.7053834919453568 0.7053819625358134 1.824158413800403e-07 -0.0990259167559372 +1.7509000000000001 0.7053840161491438 0.7053824819762523 1.7961005928032736e-07 -0.09902621122349148 +1.751 0.7053845401648822 0.7053830012900153 1.767539914224181e-07 -0.09902650560246296 +1.7511 0.7053850639920887 0.7053835204776804 1.738483085440834e-07 -0.0990267998928781 +1.7512 0.7053855876302864 0.7053840395398178 1.7089369255124387e-07 -0.09902709409476318 +1.7513 0.7053861110790067 0.7053845584769907 1.6789083639653923e-07 -0.09902738820814462 +1.7514 0.7053866343377886 0.7053850772897545 1.648404439023865e-07 -0.09902768223304881 +1.7515 0.7053871574061781 0.705385595978657 1.617432296222021e-07 -0.09902797616950204 +1.7516 0.7053876802837292 0.7053861145442382 1.5859991860794898e-07 -0.0990282700175307 +1.7517 0.7053882029700043 0.70538663298703 1.554112463303392e-07 -0.09902856377716111 +1.7518000000000002 0.705388725464573 0.7053871513075565 1.5217795844638116e-07 -0.09902885744841958 +1.7519 0.7053892477670136 0.7053876695063336 1.4890081060162097e-07 -0.09902915103133247 +1.752 0.7053897698769127 0.705388187583869 1.4558056835728417e-07 -0.09902944452592616 +1.7521000000000002 0.7053902917938641 0.705388705540662 1.4221800690925046e-07 -0.09902973793222677 +1.7522 0.7053908135174715 0.7053892233772034 1.3881391092845918e-07 -0.09903003125026077 +1.7523000000000002 0.7053913350473462 0.705389741093976 1.3536907442560087e-07 -0.09903032448005442 +1.7524000000000002 0.7053918563831082 0.7053902586914529 1.3188430052907263e-07 -0.09903061762163391 +1.7525 0.7053923775243864 0.7053907761700993 1.2836040128375026e-07 -0.09903091067502562 +1.7526000000000002 0.7053928984708187 0.7053912935303714 1.247981974948631e-07 -0.09903120364025575 +1.7527000000000001 0.7053934192220512 0.7053918107727167 1.2119851851982721e-07 -0.09903149651735065 +1.7528000000000001 0.7053939397777396 0.7053923278975733 1.175622020739564e-07 -0.09903178930633649 +1.7529000000000001 0.7053944601375485 0.70539284490537 1.138900940569898e-07 -0.09903208200723952 +1.753 0.7053949803011516 0.7053933617965272 1.1018304831023062e-07 -0.09903237462008604 +1.7531 0.7053955002682318 0.7053938785714557 1.0644192647429884e-07 -0.0990326671449023 +1.7532 0.7053960200384812 0.7053943952305566 1.0266759774973933e-07 -0.09903295958171442 +1.7533 0.7053965396116018 0.7053949117742219 9.886093870967172e-08 -0.09903325193054867 +1.7534 0.7053970589873043 0.7053954282028341 9.502283309509307e-08 -0.09903354419143126 +1.7535 0.7053975781653093 0.7053959445167659 9.115417161018047e-08 -0.09903383636438833 +1.7536 0.7053980971453477 0.7053964607163811 8.72558517071853e-08 -0.0990341284494462 +1.7537 0.7053986159271589 0.7053969768020327 8.332877739040956e-08 -0.09903442044663097 +1.7538000000000002 0.7053991345104927 0.7053974927740647 7.937385900110006e-08 -0.0990347123559688 +1.7539 0.7053996528951089 0.7053980086328109 7.539201300754694e-08 -0.09903500417748591 +1.754 0.7054001710807765 0.7053985243785952 7.138416180385576e-08 -0.09903529591120841 +1.7541000000000002 0.7054006890672748 0.7053990400117318 6.735123346361671e-08 -0.09903558755716248 +1.7542 0.7054012068543937 0.705399555532525 6.329416156296286e-08 -0.09903587911537431 +1.7543000000000002 0.7054017244419323 0.7054000709412682 5.921388493944357e-08 -0.09903617058587 +1.7544000000000002 0.7054022418296998 0.7054005862382455 5.5111347487327156e-08 -0.09903646196867566 +1.7545 0.7054027590175163 0.7054011014237306 5.098749793382151e-08 -0.09903675326381747 +1.7546000000000002 0.7054032760052114 0.7054016164979866 4.684328962223372e-08 -0.09903704447132151 +1.7547000000000001 0.7054037927926253 0.7054021314612668 4.267968029339486e-08 -0.0990373355912139 +1.7548000000000001 0.7054043093796086 0.7054026463138137 3.849763186708488e-08 -0.09903762662352072 +1.7549000000000001 0.7054048257660218 0.7054031610558598 3.4298110204375454e-08 -0.09903791756826805 +1.755 0.7054053419517363 0.705403675687627 3.008208489599373e-08 -0.099038208425482 +1.7551 0.7054058579366337 0.7054041902093271 2.585052903680829e-08 -0.09903849919518869 +1.7552 0.705406373720606 0.705404704621161 2.160441901245813e-08 -0.09903878987741417 +1.7553 0.7054068893035554 0.7054052189233191 1.734473425475669e-08 -0.09903908047218447 +1.7554 0.7054074046853955 0.7054057331159814 1.3072457025718742e-08 -0.09903937097952566 +1.7555 0.7054079198660496 0.7054062471993172 8.788572194648459e-09 -0.09903966139946374 +1.7556 0.7054084348454519 0.7054067611734856 4.494067005686442e-09 -0.09903995173202487 +1.7557 0.705408949623547 0.7054072750386345 1.899308479588746e-10 -0.09904024197723499 +1.7558000000000002 0.7054094642002905 0.7054077887949017 -4.122844962130279e-09 -0.09904053213512011 +1.7559 0.7054099785756482 0.705408302442414 -8.443267422025835e-09 -0.09904082220570633 +1.756 0.705410492749597 0.7054088159812875 -1.277034206072919e-08 -0.09904111218901958 +1.7561000000000002 0.7054110067221238 0.7054093294116275 -1.7103073175588068e-08 -0.09904140208508588 +1.7562 0.705411520493227 0.7054098427335295 -2.144046405217273e-08 -0.09904169189393129 +1.7563000000000002 0.7054120340629151 0.7054103559470771 -2.578151720496885e-08 -0.09904198161558171 +1.7564000000000002 0.7054125474312074 0.705410869052344 -3.01252345966032e-08 -0.09904227125006318 +1.7565 0.705413060598134 0.7054113820493924 -3.447061787550075e-08 -0.09904256079740163 +1.7566000000000002 0.7054135735637357 0.7054118949382748 -3.881666859760404e-08 -0.09904285025762305 +1.7567000000000002 0.7054140863280635 0.7054124077190324 -4.31623884598561e-08 -0.0990431396307534 +1.7568000000000001 0.7054145988911795 0.7054129203916955 -4.7506779528641834e-08 -0.09904342891681855 +1.7569000000000001 0.7054151112531571 0.7054134329562842 -5.184884447077733e-08 -0.09904371811584459 +1.757 0.7054156234140793 0.7054139454128076 -5.618758677793968e-08 -0.09904400722785733 +1.7571 0.70541613537404 0.705414457761264 -6.052201100177623e-08 -0.09904429625288275 +1.7572 0.7054166471331443 0.7054149700016417 -6.485112297519025e-08 -0.0990445851909468 +1.7573 0.7054171586915075 0.7054154821339174 -6.917393004322175e-08 -0.09904487404207536 +1.7574 0.7054176700492549 0.7054159941580578 -7.348944129495841e-08 -0.09904516280629427 +1.7575 0.7054181812065239 0.7054165060740187 -7.779666778232747e-08 -0.0990454514836295 +1.7576 0.7054186921634608 0.7054170178817456 -8.209462275254875e-08 -0.0990457400741069 +1.7577 0.7054192029202236 0.7054175295811733 -8.638232187278133e-08 -0.09904602857775238 +1.7578000000000003 0.7054197134769805 0.705418041172226 -9.065878345086709e-08 -0.09904631699459181 +1.7579 0.7054202238339099 0.7054185526548173 -9.492302867255414e-08 -0.09904660532465101 +1.758 0.705420733991201 0.7054190640288509 -9.917408181139842e-08 -0.09904689356795593 +1.7581000000000002 0.7054212439490531 0.7054195752942192 -1.0341097045687975e-07 -0.09904718172453235 +1.7582 0.705421753707676 0.7054200864508049 -1.0763272574598748e-07 -0.09904746979440612 +1.7583000000000002 0.70542226326729 0.70542059749848 -1.1183838256358103e-07 -0.09904775777760307 +1.7584000000000002 0.7054227726281254 0.7054211084371063 -1.1602697978264909e-07 -0.0990480456741491 +1.7585 0.7054232817904227 0.7054216192665355 -1.2019756048115005e-07 -0.09904833348406995 +1.7586000000000002 0.7054237907544326 0.7054221299866088 -1.2434917215017882e-07 -0.09904862120739145 +1.7587000000000002 0.7054242995204166 0.7054226405971572 -1.2848086691427674e-07 -0.09904890884413943 +1.7588000000000001 0.7054248080886454 0.705423151098002 -1.3259170176041501e-07 -0.09904919639433968 +1.7589000000000001 0.7054253164594 0.7054236614889541 -1.3668073874095743e-07 -0.09904948385801797 +1.759 0.7054258246329715 0.7054241717698144 -1.4074704519050074e-07 -0.09904977123520005 +1.7591 0.705426332609661 0.705424681940374 -1.4478969392710261e-07 -0.09905005852591177 +1.7592 0.7054268403897792 0.7054251920004141 -1.488077634951429e-07 -0.09905034573017885 +1.7593 0.705427347973647 0.7054257019497059 -1.528003383440002e-07 -0.0990506328480271 +1.7594 0.7054278553615945 0.7054262117880112 -1.5676650904315748e-07 -0.09905091987948222 +1.7595 0.7054283625539617 0.7054267215150816 -1.607053725059815e-07 -0.09905120682456997 +1.7596 0.7054288695510982 0.7054272311306596 -1.6461603217013399e-07 -0.0990514936833161 +1.7597 0.7054293763533632 0.7054277406344782 -1.6849759822308574e-07 -0.09905178045574638 +1.7598000000000003 0.7054298829611252 0.7054282500262603 -1.7234918779987507e-07 -0.09905206714188643 +1.7599 0.705430389374762 0.7054287593057198 -1.761699251756621e-07 -0.09905235374176204 +1.76 0.7054308955946608 0.7054292684725615 -1.7995894196001783e-07 -0.0990526402553989 +1.7601000000000002 0.705431401621218 0.7054297775264808 -1.8371537731723397e-07 -0.09905292668282274 +1.7602 0.7054319074548392 0.7054302864671638 -1.8743837814499953e-07 -0.0990532130240592 +1.7603000000000002 0.7054324130959386 0.7054307952942874 -1.9112709925828142e-07 -0.09905349927913397 +1.7604000000000002 0.7054329185449402 0.7054313040075203 -1.9478070360789967e-07 -0.0990537854480728 +1.7605 0.7054334238022759 0.7054318126065213 -1.9839836245053033e-07 -0.09905407153090127 +1.7606000000000002 0.7054339288683869 0.7054323210909412 -2.0197925555687224e-07 -0.09905435752764503 +1.7607000000000002 0.705434433743723 0.7054328294604219 -2.055225713538944e-07 -0.09905464343832986 +1.7608000000000001 0.7054349384287428 0.7054333377145962 -2.090275071572889e-07 -0.09905492926298128 +1.7609000000000001 0.7054354429239127 0.705433845853089 -2.1249326934147383e-07 -0.099055215001625 +1.761 0.7054359472297085 0.7054343538755168 -2.1591907348877948e-07 -0.09905550065428667 +1.7611 0.7054364513466129 0.7054348617814874 -2.193041446149624e-07 -0.09905578622099187 +1.7612 0.7054369552751181 0.7054353695706006 -2.2264771730104438e-07 -0.0990560717017662 +1.7613 0.7054374590157236 0.7054358772424478 -2.259490358945404e-07 -0.0990563570966353 +1.7614 0.7054379625689374 0.7054363847966132 -2.2920735465864484e-07 -0.09905664240562478 +1.7615 0.7054384659352746 0.7054368922326723 -2.3242193795958155e-07 -0.09905692762876023 +1.7616 0.7054389691152588 0.705437399550193 -2.3559206042272907e-07 -0.09905721276606717 +1.7617 0.7054394721094208 0.7054379067487363 -2.38717007099154e-07 -0.09905749781757132 +1.7618000000000003 0.7054399749182992 0.7054384138278544 -2.417960736390834e-07 -0.09905778278329813 +1.7619 0.7054404775424398 0.705438920787093 -2.4482856641680484e-07 -0.09905806766327324 +1.762 0.7054409799823957 0.7054394276259902 -2.4781380271107767e-07 -0.09905835245752222 +1.7621000000000002 0.7054414822387274 0.7054399343440766 -2.507511108751359e-07 -0.09905863716607052 +1.7622 0.7054419843120018 0.7054404409408763 -2.5363983044771055e-07 -0.09905892178894377 +1.7623000000000002 0.7054424862027936 0.7054409474159059 -2.564793123265019e-07 -0.09905920632616744 +1.7624000000000002 0.7054429879116838 0.7054414537686757 -2.592689189173658e-07 -0.09905949077776713 +1.7625 0.70544348943926 0.705441959998689 -2.620080242557443e-07 -0.0990597751437683 +1.7626000000000002 0.7054439907861166 0.7054424661054424 -2.646960141731991e-07 -0.09906005942419649 +1.7627000000000002 0.7054444919528547 0.7054429720884261 -2.6733228640843376e-07 -0.09906034361907723 +1.7628000000000001 0.7054449929400808 0.7054434779471241 -2.6991625077729675e-07 -0.09906062772843595 +1.7629000000000001 0.7054454937484085 0.7054439836810147 -2.7244732925257864e-07 -0.09906091175229824 +1.763 0.705445994378457 0.7054444892895688 -2.749249561548317e-07 -0.09906119569068948 +1.7631000000000001 0.7054464948308511 0.705444994772253 -2.773485782321672e-07 -0.09906147954363521 +1.7632 0.7054469951062221 0.7054455001285266 -2.797176547990332e-07 -0.0990617633111609 +1.7633 0.7054474952052062 0.7054460053578444 -2.820316578715232e-07 -0.09906204699329196 +1.7634 0.7054479951284456 0.7054465104596552 -2.8429007224717306e-07 -0.09906233059005391 +1.7635 0.7054484948765877 0.7054470154334025 -2.8649239566108653e-07 -0.09906261410147219 +1.7636 0.7054489944502847 0.7054475202785242 -2.8863813887961e-07 -0.09906289752757214 +1.7637 0.7054494938501947 0.7054480249944537 -2.9072682580788545e-07 -0.09906318086837929 +1.7638000000000003 0.7054499930769801 0.7054485295806192 -2.9275799356270893e-07 -0.09906346412391903 +1.7639 0.7054504921313083 0.7054490340364439 -2.947311926702889e-07 -0.0990637472942168 +1.764 0.7054509910138511 0.7054495383613464 -2.966459870419602e-07 -0.09906403037929797 +1.7641000000000002 0.7054514897252852 0.7054500425547412 -2.985019541754119e-07 -0.09906431337918793 +1.7642 0.7054519882662913 0.7054505466160379 -3.0029868518244296e-07 -0.09906459629391215 +1.7643000000000002 0.7054524866375547 0.705451050544642 -3.020357849208011e-07 -0.09906487912349594 +1.7644000000000002 0.7054529848397642 0.7054515543399551 -3.0371287204622455e-07 -0.09906516186796471 +1.7645 0.7054534828736129 0.705452058001375 -3.0532957909917835e-07 -0.0990654445273439 +1.7646000000000002 0.7054539807397977 0.7054525615282952 -3.0688555260893757e-07 -0.09906572710165878 +1.7647 0.7054544784390187 0.7054530649201058 -3.083804531664458e-07 -0.09906600959093473 +1.7648000000000001 0.7054549759719797 0.7054535681761935 -3.098139555110513e-07 -0.09906629199519706 +1.7649000000000001 0.705455473339388 0.7054540712959418 -3.1118574853050696e-07 -0.09906657431447122 +1.765 0.7054559705419537 0.7054545742787307 -3.124955353997483e-07 -0.09906685654878244 +1.7651000000000001 0.7054564675803903 0.7054550771239374 -3.1374303362252665e-07 -0.09906713869815612 +1.7652 0.7054569644554134 0.7054555798309361 -3.149279751077372e-07 -0.09906742076261749 +1.7653 0.7054574611677422 0.7054560823990986 -3.1605010616941875e-07 -0.09906770274219197 +1.7654 0.7054579577180979 0.7054565848277938 -3.1710918768634855e-07 -0.0990679846369048 +1.7655 0.7054584541072042 0.7054570871163883 -3.181049950326531e-07 -0.0990682664467813 +1.7656 0.705458950335787 0.7054575892642465 -3.190373182235251e-07 -0.09906854817184677 +1.7657 0.705459446404574 0.7054580912707309 -3.199059618944067e-07 -0.09906882981212645 +1.7658000000000003 0.7054599423142954 0.7054585931352011 -3.2071074537037836e-07 -0.09906911136764564 +1.7659 0.7054604380656826 0.7054590948570163 -3.2145150268697575e-07 -0.09906939283842961 +1.766 0.7054609336594689 0.7054595964355337 -3.221280826318229e-07 -0.09906967422450366 +1.7661000000000002 0.7054614290963885 0.7054600978701084 -3.2274034883483793e-07 -0.09906995552589297 +1.7662 0.7054619243771778 0.7054605991600948 -3.2328817967108847e-07 -0.09907023674262283 +1.7663000000000002 0.7054624195025736 0.705461100304846 -3.237714683995696e-07 -0.09907051787471849 +1.7664000000000002 0.7054629144733138 0.7054616013037142 -3.241901230799371e-07 -0.09907079892220517 +1.7665 0.7054634092901368 0.7054621021560505 -3.2454406669046865e-07 -0.09907107988510809 +1.7666000000000002 0.7054639039537824 0.7054626028612054 -3.248332370794915e-07 -0.09907136076345241 +1.7667 0.7054643984649902 0.7054631034185295 -3.2505758697926046e-07 -0.09907164155726339 +1.7668000000000001 0.7054648928245004 0.7054636038273724 -3.2521708405452987e-07 -0.09907192226656628 +1.7669000000000001 0.7054653870330534 0.7054641040870837 -3.2531171088867605e-07 -0.09907220289138621 +1.767 0.7054658810913893 0.705464604197013 -3.2534146490736937e-07 -0.09907248343174838 +1.7671000000000001 0.7054663750002481 0.7054651041565101 -3.2530635850347434e-07 -0.09907276388767794 +1.7672 0.7054668687603699 0.7054656039649251 -3.252064189190884e-07 -0.09907304425920012 +1.7673 0.7054673623724936 0.7054661036216086 -3.250416882871754e-07 -0.09907332454634005 +1.7674 0.7054678558373582 0.7054666031259114 -3.2481222363156537e-07 -0.09907360474912291 +1.7675 0.7054683491557012 0.7054671024771857 -3.245180968114436e-07 -0.09907388486757379 +1.7676 0.7054688423282598 0.7054676016747845 -3.2415939452828946e-07 -0.09907416490171793 +1.7677 0.7054693353557695 0.7054681007180614 -3.237362182911818e-07 -0.0990744448515804 +1.7678000000000003 0.705469828238965 0.7054685996063719 -3.2324868438210475e-07 -0.09907472471718634 +1.7679 0.7054703209785791 0.7054690983390723 -3.2269692381431403e-07 -0.09907500449856087 +1.768 0.7054708135753436 0.7054695969155211 -3.22081082346215e-07 -0.09907528419572913 +1.7681000000000002 0.7054713060299876 0.705470095335078 -3.214013203980959e-07 -0.09907556380871615 +1.7682 0.7054717983432395 0.7054705935971048 -3.206578130382498e-07 -0.09907584333754711 +1.7683000000000002 0.7054722905158244 0.7054710917009657 -3.198507498997083e-07 -0.09907612278224709 +1.7684000000000002 0.7054727825484663 0.7054715896460264 -3.1898033518718005e-07 -0.09907640214284115 +1.7685 0.705473274441886 0.7054720874316553 -3.1804678755908977e-07 -0.09907668141935438 +1.7686000000000002 0.705473766196802 0.7054725850572237 -3.170503401692115e-07 -0.09907696061181182 +1.7687 0.7054742578139306 0.7054730825221045 -3.1599124051401306e-07 -0.0990772397202386 +1.7688000000000001 0.7054747492939845 0.7054735798256748 -3.148697503979614e-07 -0.09907751874465973 +1.7689000000000001 0.7054752406376739 0.7054740769673133 -3.1368614589188937e-07 -0.09907779768510026 +1.769 0.7054757318457052 0.7054745739464028 -3.124407172636068e-07 -0.0990780765415852 +1.7691000000000001 0.7054762229187825 0.7054750707623288 -3.1113376887381694e-07 -0.09907835531413961 +1.7692 0.7054767138576059 0.705475567414481 -3.097656191483611e-07 -0.09907863400278855 +1.7693 0.7054772046628719 0.7054760639022517 -3.0833660046719613e-07 -0.09907891260755697 +1.7694 0.7054776953352733 0.7054765602250374 -3.0684705908806675e-07 -0.09907919112846994 +1.7695 0.7054781858754988 0.7054770563822383 -3.052973551048721e-07 -0.09907946956555244 +1.7696 0.7054786762842338 0.705477552373259 -3.0368786225337674e-07 -0.0990797479188295 +1.7697 0.7054791665621585 0.7054780481975079 -3.020189679597829e-07 -0.09908002618832602 +1.7698000000000003 0.7054796567099494 0.7054785438543976 -3.0029107314644143e-07 -0.09908030437406704 +1.7699 0.7054801467282785 0.7054790393433454 -2.985045921971574e-07 -0.09908058247607753 +1.77 0.7054806366178128 0.7054795346637733 -2.9665995279412605e-07 -0.09908086049438247 +1.7701000000000002 0.7054811263792151 0.7054800298151079 -2.947575958936466e-07 -0.09908113842900682 +1.7702 0.7054816160131429 0.7054805247967806 -2.927979755491805e-07 -0.09908141627997552 +1.7703000000000002 0.7054821055202486 0.7054810196082275 -2.907815588454321e-07 -0.09908169404731348 +1.7704000000000002 0.7054825949011799 0.7054815142488906 -2.8870882576650936e-07 -0.09908197173104571 +1.7705 0.7054830841565787 0.7054820087182168 -2.865802691091879e-07 -0.09908224933119708 +1.7706000000000002 0.7054835732870816 0.7054825030156577 -2.843963943510719e-07 -0.09908252684779251 +1.7707 0.7054840622933194 0.705482997140672 -2.8215771949793855e-07 -0.09908280428085692 +1.7708000000000002 0.7054845511759182 0.705483491092723 -2.798647750178185e-07 -0.09908308163041529 +1.7709000000000001 0.705485039935497 0.7054839848712802 -2.775181036744623e-07 -0.09908335889649252 +1.771 0.7054855285726692 0.7054844784758189 -2.751182604336655e-07 -0.09908363607911341 +1.7711000000000001 0.7054860170880424 0.7054849719058203 -2.726658122863268e-07 -0.0990839131783029 +1.7712 0.7054865054822175 0.7054854651607722 -2.701613381443646e-07 -0.09908419019408589 +1.7713 0.7054869937557896 0.7054859582401685 -2.676054286984697e-07 -0.09908446712648722 +1.7714 0.7054874819093467 0.7054864511435095 -2.6499868631055246e-07 -0.09908474397553173 +1.7715 0.7054879699434707 0.7054869438703026 -2.6234172481251483e-07 -0.09908502074124433 +1.7716 0.7054884578587364 0.705487436420061 -2.596351694160448e-07 -0.09908529742364981 +1.7717 0.7054889456557121 0.7054879287923059 -2.568796564940412e-07 -0.0990855740227731 +1.7718000000000003 0.7054894333349585 0.7054884209865642 -2.5407583351122476e-07 -0.09908585053863893 +1.7719 0.7054899208970302 0.7054889130023706 -2.5122435885760463e-07 -0.09908612697127218 +1.772 0.7054904083424738 0.705489404839267 -2.483259016437811e-07 -0.09908640332069772 +1.7721000000000002 0.7054908956718288 0.705489896496802 -2.453811415829843e-07 -0.09908667958694027 +1.7722 0.7054913828856275 0.7054903879745327 -2.4239076882801025e-07 -0.09908695577002476 +1.7723000000000002 0.7054918699843943 0.7054908792720225 -2.3935548378734017e-07 -0.09908723186997585 +1.7724000000000002 0.7054923569686462 0.7054913703888428 -2.3627599702105706e-07 -0.09908750788681839 +1.7725 0.7054928438388923 0.7054918613245733 -2.331530290118622e-07 -0.0990877838205772 +1.7726000000000002 0.7054933305956341 0.7054923520788008 -2.2998730999507222e-07 -0.09908805967127703 +1.7727 0.7054938172393648 0.7054928426511204 -2.2677957985106634e-07 -0.09908833543894265 +1.7728000000000002 0.7054943037705699 0.705493333041135 -2.2353058786589441e-07 -0.09908861112359879 +1.7729000000000001 0.7054947901897264 0.7054938232484562 -2.2024109259943803e-07 -0.09908888672527029 +1.773 0.7054952764973035 0.7054943132727033 -2.1691186168418253e-07 -0.09908916224398188 +1.7731000000000001 0.7054957626937612 0.7054948031135037 -2.135436716448058e-07 -0.09908943767975822 +1.7732 0.705496248779552 0.7054952927704938 -2.1013730774552264e-07 -0.09908971303262415 +1.7733 0.7054967347551191 0.7054957822433183 -2.0669356378538728e-07 -0.09908998830260425 +1.7734 0.7054972206208978 0.7054962715316302 -2.0321324190053502e-07 -0.09909026348972338 +1.7735 0.7054977063773142 0.7054967606350918 -1.9969715241152652e-07 -0.0990905385940062 +1.7736 0.7054981920247858 0.7054972495533736 -1.961461135943643e-07 -0.09909081361547743 +1.7737 0.7054986775637213 0.7054977382861553 -1.9256095154518427e-07 -0.09909108855416177 +1.7738000000000003 0.70549916299452 0.7054982268331251 -1.889424999269862e-07 -0.09909136341008387 +1.7739 0.7054996483175726 0.7054987151939808 -1.8529159981697796e-07 -0.09909163818326844 +1.774 0.7055001335332607 0.7054992033684289 -1.816090995088171e-07 -0.09909191287374018 +1.7741000000000002 0.7055006186419562 0.7054996913561853 -1.7789585426628007e-07 -0.09909218748152374 +1.7742 0.7055011036440222 0.7055001791569749 -1.741527262053011e-07 -0.09909246200664378 +1.7743000000000002 0.7055015885398126 0.7055006667705321 -1.7038058404937606e-07 -0.09909273644912492 +1.7744000000000002 0.7055020733296714 0.7055011541966004 -1.6658030290925274e-07 -0.09909301080899187 +1.7745 0.7055025580139336 0.7055016414349333 -1.6275276409731532e-07 -0.09909328508626927 +1.7746000000000002 0.7055030425929242 0.7055021284852931 -1.5889885496278566e-07 -0.09909355928098171 +1.7747 0.705503527066959 0.705502615347452 -1.5501946861763705e-07 -0.09909383339315378 +1.7748000000000002 0.7055040114363438 0.7055031020211919 -1.5111550378220373e-07 -0.09909410742281016 +1.7749000000000001 0.7055044957013751 0.7055035885063046 -1.471878645579322e-07 -0.09909438136997548 +1.775 0.7055049798623395 0.7055040748025911 -1.4323746020186712e-07 -0.09909465523467431 +1.7751000000000001 0.7055054639195135 0.7055045609098627 -1.3926520495144423e-07 -0.09909492901693126 +1.7752000000000001 0.705505947873164 0.70550504682794 -1.3527201778336384e-07 -0.09909520271677091 +1.7753 0.705506431723548 0.7055055325566539 -1.3125882222103646e-07 -0.09909547633421784 +1.7754 0.7055069154709124 0.7055060180958453 -1.2722654610559936e-07 -0.09909574986929665 +1.7755 0.7055073991154944 0.7055065034453649 -1.2317612137734135e-07 -0.09909602332203193 +1.7756 0.7055078826575203 0.7055069886050733 -1.191084839022305e-07 -0.09909629669244815 +1.7757 0.705508366097207 0.7055074735748412 -1.1502457319435833e-07 -0.0990965699805699 +1.7758000000000003 0.7055088494347614 0.7055079583545498 -1.1092533223899803e-07 -0.09909684318642174 +1.7759 0.7055093326703801 0.7055084429440901 -1.0681170727229461e-07 -0.09909711631002822 +1.776 0.7055098158042492 0.7055089273433633 -1.0268464754187301e-07 -0.09909738935141389 +1.7761000000000002 0.7055102988365449 0.7055094115522806 -9.854510511862064e-08 -0.09909766231060324 +1.7762 0.705510781767433 0.7055098955707639 -9.439403464775453e-08 -0.09909793518762076 +1.7763000000000002 0.7055112645970693 0.705510379398745 -9.023239314846082e-08 -0.09909820798249103 +1.7764000000000002 0.7055117473255986 0.705510863036166 -8.606113978317648e-08 -0.0990984806952385 +1.7765 0.7055122299531564 0.7055113464829792 -8.188123563381e-08 -0.09909875332588772 +1.7766000000000002 0.705512712479867 0.7055118297391477 -7.769364350138086e-08 -0.09909902587446313 +1.7767 0.7055131949058445 0.7055123128046443 -7.34993276562193e-08 -0.09909929834098921 +1.7768000000000002 0.7055136772311932 0.7055127956794527 -6.929925363630476e-08 -0.09909957072549047 +1.7769000000000001 0.7055141594560064 0.7055132783635664 -6.509438801394554e-08 -0.09909984302799135 +1.777 0.7055146415803675 0.7055137608569896 -6.08856981785047e-08 -0.09910011524851636 +1.7771000000000001 0.7055151236043491 0.705514243159737 -5.66741521119702e-08 -0.09910038738708993 +1.7772000000000001 0.7055156055280136 0.7055147252718332 -5.246071816951241e-08 -0.0991006594437365 +1.7773 0.7055160873514127 0.7055152071933135 -4.8246364853319484e-08 -0.09910093141848048 +1.7774 0.7055165690745882 0.7055156889242236 -4.4032060590823863e-08 -0.09910120331134631 +1.7775 0.7055170506975712 0.7055161704646191 -3.981877351292868e-08 -0.09910147512235841 +1.7776 0.7055175322203826 0.7055166518145668 -3.5607471232938954e-08 -0.09910174685154124 +1.7777 0.7055180136430328 0.705517132974143 -3.1399120620613855e-08 -0.0991020184989192 +1.7778000000000003 0.705518494965522 0.7055176139434349 -2.7194687583862592e-08 -0.09910229006451668 +1.7779 0.7055189761878397 0.7055180947225399 -2.2995136847187708e-08 -0.09910256154835806 +1.778 0.7055194573099652 0.7055185753115653 -1.880143172703838e-08 -0.09910283295046773 +1.7781000000000002 0.705519938331868 0.7055190557106295 -1.4614533917246819e-08 -0.09910310427087014 +1.7782 0.7055204192535063 0.7055195359198604 -1.0435403256358472e-08 -0.09910337550958959 +1.7783000000000002 0.705520900074829 0.7055200159393966 -6.264997522500981e-09 -0.0991036466666505 +1.7784 0.7055213807957741 0.7055204957693866 -2.1042722061354047e-09 -0.0991039177420772 +1.7785 0.7055218614162695 0.7055209754099896 2.045819709819985e-09 -0.09910418873589401 +1.7786000000000002 0.7055223419362334 0.7055214548613743 6.184327966396452e-09 -0.09910445964812535 +1.7787 0.7055228223555732 0.7055219341237202 1.0310305241512108e-08 -0.0991047304787955 +1.7788000000000002 0.7055233026741865 0.7055224131972163 1.442280737635332e-08 -0.09910500122792884 +1.7789000000000001 0.7055237828919604 0.7055228920820621 1.8520893584408893e-08 -0.09910527189554963 +1.779 0.7055242630087726 0.7055233707784669 2.2603626668310506e-08 -0.09910554248168221 +1.7791000000000001 0.7055247430244904 0.7055238492866504 2.6670073233203695e-08 -0.09910581298635093 +1.7792000000000001 0.7055252229389712 0.7055243276068417 3.071930389925148e-08 -0.0991060834095801 +1.7793 0.7055257027520625 0.70552480573928 3.475039351934217e-08 -0.09910635375139398 +1.7794 0.7055261824636019 0.7055252836842143 3.876242138552144e-08 -0.09910662401181687 +1.7795 0.7055266620734169 0.7055257614419036 4.2754471440628605e-08 -0.09910689419087304 +1.7796 0.7055271415813257 0.7055262390126165 4.6725632488198166e-08 -0.09910716428858675 +1.7797 0.7055276209871365 0.7055267163966312 5.067499839021827e-08 -0.09910743430498231 +1.7798000000000003 0.7055281002906482 0.705527193594236 5.4601668296114236e-08 -0.09910770424008401 +1.7799 0.7055285794916493 0.7055276706057277 5.850474682836393e-08 -0.09910797409391599 +1.78 0.7055290585899199 0.7055281474314139 6.238334428892989e-08 -0.09910824386650258 +1.7801000000000002 0.7055295375852293 0.705528624071611 6.623657687609974e-08 -0.099108513557868 +1.7802 0.7055300164773385 0.7055291005266449 7.00635668753058e-08 -0.0991087831680365 +1.7803000000000002 0.7055304952659988 0.7055295767968506 7.386344284820989e-08 -0.09910905269703228 +1.7804 0.7055309739509519 0.705530052882573 7.763533984954385e-08 -0.09910932214487962 +1.7805 0.7055314525319307 0.7055305287841651 8.137839961966375e-08 -0.09910959151160265 +1.7806000000000002 0.705531931008659 0.7055310045019898 8.509177077536956e-08 -0.09910986079722557 +1.7807 0.705532409380851 0.7055314800364189 8.877460901460243e-08 -0.09911013000177263 +1.7808000000000002 0.7055328876482123 0.7055319553878332 9.242607726736574e-08 -0.09911039912526798 +1.7809000000000001 0.7055333658104399 0.7055324305566222 9.604534594379044e-08 -0.09911066816773581 +1.781 0.7055338438672216 0.7055329055431845 9.96315931006686e-08 -0.09911093712920038 +1.7811000000000001 0.7055343218182368 0.7055333803479267 1.0318400460104793e-07 -0.09911120600968576 +1.7812000000000001 0.7055347996631556 0.7055338549712646 1.0670177433974581e-07 -0.09911147480921612 +1.7813 0.7055352774016401 0.7055343294136227 1.1018410440641335e-07 -0.09911174352781568 +1.7814 0.7055357550333439 0.7055348036754334 1.1363020526247714e-07 -0.0991120121655085 +1.7815 0.7055362325579122 0.7055352777571378 1.170392959146116e-07 -0.0991122807223188 +1.7816 0.7055367099749819 0.7055357516591851 1.2041060412290583e-07 -0.09911254919827073 +1.7817 0.7055371872841812 0.7055362253820326 1.2374336654658036e-07 -0.09911281759338829 +1.7818000000000003 0.7055376644851312 0.705536698926146 1.2703682892092893e-07 -0.09911308590769574 +1.7819 0.7055381415774442 0.7055371722919983 1.3029024623772978e-07 -0.09911335414121705 +1.782 0.7055386185607251 0.705537645480071 1.3350288291871792e-07 -0.09911362229397641 +1.7821000000000002 0.7055390954345707 0.7055381184908531 1.366740129543631e-07 -0.0991138903659979 +1.7822 0.7055395721985706 0.7055385913248414 1.3980292006693373e-07 -0.09911415835730567 +1.7823000000000002 0.7055400488523061 0.7055390639825398 1.4288889796029713e-07 -0.09911442626792372 +1.7824 0.7055405253953518 0.7055395364644604 1.4593125033379728e-07 -0.0991146940978762 +1.7825 0.7055410018272743 0.7055400087711219 1.4892929115981057e-07 -0.0991149618471871 +1.7826000000000002 0.7055414781476335 0.7055404809030502 1.5188234477048201e-07 -0.09911522951588052 +1.7827 0.7055419543559815 0.705540952860779 1.54789746034667e-07 -0.09911549710398049 +1.7828000000000002 0.705542430451864 0.7055414246448487 1.5765084050711753e-07 -0.09911576461151111 +1.7829000000000002 0.70554290643482 0.7055418962558062 1.6046498459848513e-07 -0.09911603203849642 +1.783 0.7055433823043806 0.7055423676942054 1.6323154566552645e-07 -0.09911629938496039 +1.7831000000000001 0.7055438580600718 0.7055428389606069 1.659499021984534e-07 -0.09911656665092713 +1.7832000000000001 0.7055443337014117 0.7055433100555779 1.6861944394583328e-07 -0.09911683383642061 +1.7833 0.7055448092279124 0.7055437809796915 1.7123957203601936e-07 -0.09911710094146482 +1.7834 0.7055452846390803 0.7055442517335277 1.7380969914715383e-07 -0.09911736796608384 +1.7835 0.705545759934415 0.7055447223176725 1.763292495904345e-07 -0.09911763491030164 +1.7836 0.7055462351134103 0.7055451927327174 1.7879765950440385e-07 -0.0991179017741422 +1.7837 0.7055467101755537 0.7055456629792602 1.8121437691046016e-07 -0.0991181685576295 +1.7838000000000003 0.7055471851203275 0.7055461330579044 1.8357886189326877e-07 -0.09911843526078752 +1.7839 0.7055476599472081 0.7055466029692593 1.858905866909677e-07 -0.09911870188364026 +1.784 0.7055481346556662 0.7055470727139395 1.881490358131288e-07 -0.09911896842621169 +1.7841000000000002 0.7055486092451675 0.7055475422925649 1.903537061483107e-07 -0.0991192348885257 +1.7842 0.705549083715172 0.7055480117057606 1.9250410708201993e-07 -0.09911950127060631 +1.7843000000000002 0.7055495580651349 0.7055484809541572 1.945997606667138e-07 -0.09911976757247742 +1.7844 0.7055500322945063 0.7055489500383899 1.966402016356783e-07 -0.09912003379416298 +1.7845 0.7055505064027314 0.7055494189590985 1.9862497755568365e-07 -0.09912029993568691 +1.7846000000000002 0.705550980389251 0.7055498877169277 2.0055364891025107e-07 -0.09912056599707314 +1.7847 0.7055514542535009 0.7055503563125272 2.0242578919679732e-07 -0.09912083197834556 +1.7848000000000002 0.7055519279949127 0.7055508247465505 2.0424098502030974e-07 -0.09912109787952814 +1.7849000000000002 0.7055524016129139 0.7055512930196557 2.0599883620436854e-07 -0.09912136370064473 +1.785 0.7055528751069274 0.7055517611325048 2.07698955877883e-07 -0.09912162944171929 +1.7851000000000001 0.7055533484763726 0.7055522290857639 2.0934097053407208e-07 -0.09912189510277561 +1.7852000000000001 0.7055538217206647 0.7055526968801027 2.1092452012066998e-07 -0.09912216068383765 +1.7853 0.7055542948392153 0.7055531645161948 2.1244925812666238e-07 -0.09912242618492922 +1.7854 0.7055547678314323 0.7055536319947172 2.1391485166902258e-07 -0.0991226916060742 +1.7855 0.7055552406967207 0.7055540993163505 2.1532098153434487e-07 -0.09912295694729648 +1.7856 0.7055557134344814 0.7055545664817784 2.1666734226211126e-07 -0.09912322220861987 +1.7857 0.7055561860441132 0.7055550334916878 2.1795364222448876e-07 -0.09912348739006828 +1.7858000000000003 0.7055566585250113 0.7055555003467684 2.191796037095961e-07 -0.09912375249166555 +1.7859 0.7055571308765677 0.7055559670477127 2.2034496287987038e-07 -0.09912401751343544 +1.786 0.7055576030981724 0.7055564335952159 2.2144946995594772e-07 -0.09912428245540178 +1.7861000000000002 0.7055580751892128 0.7055568999899756 2.2249288920278554e-07 -0.09912454731758844 +1.7862 0.7055585471490737 0.7055573662326919 2.2347499897129586e-07 -0.0991248121000192 +1.7863000000000002 0.7055590189771378 0.7055578323240672 2.2439559178855095e-07 -0.09912507680271784 +1.7864 0.7055594906727858 0.7055582982648055 2.2525447433696666e-07 -0.09912534142570821 +1.7865 0.7055599622353964 0.7055587640556131 2.2605146758614136e-07 -0.09912560596901408 +1.7866000000000002 0.7055604336643468 0.7055592296971978 2.2678640674428374e-07 -0.09912587043265926 +1.7867 0.7055609049590118 0.7055596951902687 2.2745914134841838e-07 -0.09912613481666743 +1.7868000000000002 0.7055613761187658 0.7055601605355374 2.280695352296913e-07 -0.09912639912106247 +1.7869000000000002 0.7055618471429811 0.7055606257337154 2.286174666313312e-07 -0.09912666334586803 +1.787 0.7055623180310293 0.7055610907855163 2.2910282818783267e-07 -0.09912692749110798 +1.7871000000000001 0.7055627887822808 0.7055615556916544 2.2952552685556737e-07 -0.09912719155680597 +1.7872000000000001 0.7055632593961055 0.7055620204528444 2.29885484107073e-07 -0.09912745554298584 +1.7873 0.705563729871872 0.7055624850698023 2.3018263583390874e-07 -0.09912771944967122 +1.7874 0.705564200208949 0.7055629495432443 2.3041693236053318e-07 -0.09912798327688593 +1.7875 0.7055646704067045 0.7055634138738867 2.3058833846512083e-07 -0.0991282470246536 +1.7876 0.7055651404645065 0.7055638780624464 2.3069683340731784e-07 -0.09912851069299802 +1.7877 0.7055656103817224 0.7055643421096398 2.3074241087273073e-07 -0.09912877428194283 +1.7878000000000003 0.7055660801577205 0.705564806016184 2.3072507903537653e-07 -0.09912903779151178 +1.7879 0.7055665497918687 0.7055652697827951 2.3064486052298827e-07 -0.09912930122172853 +1.788 0.7055670192835359 0.7055657334101892 2.305017923823205e-07 -0.09912956457261682 +1.7881000000000002 0.705567488632091 0.7055661968990816 2.3029592613466043e-07 -0.09912982784420027 +1.7882 0.7055679578369038 0.7055666602501866 2.3002732763705014e-07 -0.09913009103650257 +1.7883000000000002 0.705568426897345 0.705567123464218 2.2969607722106433e-07 -0.09913035414954735 +1.7884 0.7055688958127866 0.7055675865418887 2.2930226952627697e-07 -0.0991306171833583 +1.7885 0.7055693645826011 0.7055680494839099 2.2884601357658907e-07 -0.09913088013795912 +1.7886000000000002 0.705569833206163 0.7055685122909919 2.2832743271777867e-07 -0.09913114301337335 +1.7887 0.705570301682848 0.7055689749638433 2.277466645134174e-07 -0.09913140580962472 +1.7888000000000002 0.7055707700120333 0.7055694375031706 2.2710386086283174e-07 -0.09913166852673677 +1.7889000000000002 0.7055712381930984 0.7055698999096793 2.2639918782763058e-07 -0.09913193116473323 +1.789 0.7055717062254241 0.7055703621840725 2.2563282562476639e-07 -0.09913219372363762 +1.7891000000000001 0.7055721741083937 0.7055708243270512 2.24804968640413e-07 -0.09913245620347362 +1.7892000000000001 0.7055726418413926 0.705571286339314 2.2391582527037102e-07 -0.09913271860426477 +1.7893000000000001 0.7055731094238086 0.7055717482215575 2.229656179825179e-07 -0.09913298092603473 +1.7894 0.7055735768550317 0.7055722099744752 2.2195458319884676e-07 -0.09913324316880699 +1.7895 0.7055740441344557 0.7055726715987582 2.2088297123301626e-07 -0.09913350533260519 +1.7896 0.7055745112614761 0.705573133095095 2.1975104622790065e-07 -0.09913376741745294 +1.7897 0.7055749782354916 0.7055735944641703 2.1855908614171193e-07 -0.09913402942337375 +1.7898000000000003 0.7055754450559046 0.7055740557066665 2.173073826230998e-07 -0.09913429135039124 +1.7899 0.7055759117221202 0.705574516823262 2.159962409764571e-07 -0.09913455319852887 +1.79 0.7055763782335472 0.7055749778146323 2.146259800717143e-07 -0.09913481496781029 +1.7901000000000002 0.705576844589598 0.705575438681449 2.1319693225760328e-07 -0.09913507665825899 +1.7902 0.7055773107896884 0.7055758994243799 2.1170944328532948e-07 -0.09913533826989851 +1.7903000000000002 0.7055777768332383 0.7055763600440892 2.101638722634691e-07 -0.09913559980275237 +1.7904 0.7055782427196715 0.7055768205412369 2.0856059150531348e-07 -0.09913586125684404 +1.7905 0.7055787084484161 0.7055772809164786 2.068999865011134e-07 -0.0991361226321971 +1.7906000000000002 0.7055791740189044 0.7055777411704662 2.051824557654236e-07 -0.09913638392883505 +1.7907 0.7055796394305732 0.7055782013038467 2.0340841079546923e-07 -0.09913664514678139 +1.7908000000000002 0.7055801046828636 0.7055786613172629 2.0157827597400146e-07 -0.09913690628605962 +1.7909000000000002 0.7055805697752217 0.705579121211352 1.9969248842358067e-07 -0.0991371673466932 +1.791 0.7055810347070981 0.7055795809867474 1.9775149791290136e-07 -0.0991374283287056 +1.7911000000000001 0.7055814994779486 0.7055800406440768 1.9575576678046436e-07 -0.09913768923212028 +1.7912000000000001 0.7055819640872343 0.7055805001839632 1.937057698027378e-07 -0.09913795005696074 +1.7913000000000001 0.7055824285344209 0.705580959607024 1.9160199408660428e-07 -0.0991382108032504 +1.7914 0.7055828928189799 0.7055814189138716 1.894449389444608e-07 -0.09913847147101273 +1.7915 0.7055833569403883 0.7055818781051129 1.872351157970742e-07 -0.09913873206027118 +1.7916 0.7055838208981287 0.7055823371813486 1.8497304801398662e-07 -0.0991389925710492 +1.7917 0.7055842846916893 0.7055827961431742 1.8265927082677935e-07 -0.09913925300337022 +1.7918000000000003 0.7055847483205642 0.7055832549911788 1.8029433120764216e-07 -0.0991395133572576 +1.7919 0.7055852117842536 0.705583713725946 1.7787878770283982e-07 -0.0991397736327348 +1.792 0.7055856750822636 0.705584172348053 1.7541321033209822e-07 -0.09914003382982522 +1.7921 0.7055861382141071 0.7055846308580708 1.7289818043941807e-07 -0.09914029394855228 +1.7922 0.7055866011793025 0.7055850892565638 1.703342905577665e-07 -0.09914055398893935 +1.7923000000000002 0.7055870639773754 0.7055855475440904 1.6772214427723808e-07 -0.09914081395100986 +1.7924 0.7055875266078575 0.705586005721202 1.6506235608892972e-07 -0.09914107383478715 +1.7925 0.7055879890702875 0.7055864637884431 1.6235555126004053e-07 -0.0991413336402946 +1.7926000000000002 0.7055884513642112 0.705586921746352 1.5960236566733843e-07 -0.09914159336755565 +1.7927 0.7055889134891806 0.7055873795954593 1.5680344567226e-07 -0.09914185301659356 +1.7928000000000002 0.7055893754447551 0.7055878373362892 1.5395944792662153e-07 -0.09914211258743173 +1.7929000000000002 0.7055898372305014 0.7055882949693579 1.5107103928588272e-07 -0.09914237208009347 +1.793 0.7055902988459929 0.7055887524951753 1.4813889656628554e-07 -0.09914263149460216 +1.7931000000000001 0.7055907602908114 0.7055892099142433 1.4516370647546517e-07 -0.09914289083098114 +1.7932000000000001 0.7055912215645452 0.7055896672270561 1.4214616537999714e-07 -0.0991431500892537 +1.7933000000000001 0.7055916826667907 0.7055901244341012 1.390869791978444e-07 -0.09914340926944316 +1.7934 0.7055921435971517 0.7055905815358573 1.3598686318672115e-07 -0.09914366837157287 +1.7935 0.7055926043552397 0.7055910385327964 1.328465418018454e-07 -0.09914392739566612 +1.7936 0.7055930649406745 0.7055914954253815 1.2966674852940563e-07 -0.09914418634174615 +1.7937 0.7055935253530835 0.7055919522140687 1.2644822570268e-07 -0.0991444452098364 +1.7938000000000003 0.7055939855921023 0.7055924088993051 1.2319172432856407e-07 -0.09914470399995999 +1.7939 0.7055944456573744 0.70559286548153 1.1989800394185401e-07 -0.09914496271214028 +1.794 0.7055949055485522 0.705593321961175 1.165678323901409e-07 -0.09914522134640058 +1.7941 0.7055953652652953 0.7055937783386625 1.1320198566033834e-07 -0.09914547990276411 +1.7942 0.7055958248072729 0.7055942346144066 1.0980124774337408e-07 -0.09914573838125412 +1.7943000000000002 0.7055962841741615 0.7055946907888138 1.0636641037398142e-07 -0.09914599678189387 +1.7944 0.7055967433656471 0.7055951468622803 1.0289827291273812e-07 -0.09914625510470658 +1.7945 0.7055972023814242 0.7055956028351953 9.939764212402169e-08 -0.09914651334971548 +1.7946000000000002 0.7055976612211958 0.7055960587079385 9.586533202682324e-08 -0.09914677151694391 +1.7947 0.7055981198846737 0.7055965144808808 9.230216364147781e-08 -0.09914702960641497 +1.7948000000000002 0.7055985783715787 0.705596970154384 8.870896485088653e-08 -0.09914728761815193 +1.7949000000000002 0.7055990366816403 0.7055974257288018 8.508657019581922e-08 -0.09914754555217803 +1.795 0.7055994948145974 0.7055978812044779 8.143582068062538e-08 -0.09914780340851642 +1.7951000000000001 0.7055999527701977 0.7055983365817471 7.775756358588404e-08 -0.09914806118719033 +1.7952000000000001 0.7056004105481983 0.7055987918609354 7.405265224462443e-08 -0.09914831888822295 +1.7953000000000001 0.7056008681483651 0.7055992470423592 7.032194587926199e-08 -0.09914857651163744 +1.7954 0.7056013255704734 0.705599702126326 6.656630937088015e-08 -0.09914883405745697 +1.7955 0.7056017828143082 0.7056001571131333 6.278661309443156e-08 -0.09914909152570472 +1.7956 0.7056022398796634 0.7056006120030698 5.8983732670672695e-08 -0.09914934891640388 +1.7957 0.7056026967663427 0.7056010667964144 5.515854881003868e-08 -0.09914960622957754 +1.7958000000000003 0.7056031534741589 0.705601521493437 5.1311947073251485e-08 -0.09914986346524891 +1.7959 0.705603610002935 0.7056019760943973 4.7444817692643415e-08 -0.09915012062344114 +1.796 0.7056040663525028 0.7056024305995456 4.3558055348377756e-08 -0.09915037770417734 +1.7961 0.7056045225227043 0.7056028850091227 3.965255896895559e-08 -0.09915063470748064 +1.7962 0.7056049785133905 0.7056033393233593 3.5729231523048965e-08 -0.0991508916333741 +1.7963000000000002 0.7056054343244232 0.7056037935424773 3.178897980959938e-08 -0.09915114848188096 +1.7964 0.7056058899556732 0.7056042476666877 2.7832714249650947e-08 -0.0991514052530243 +1.7965 0.7056063454070209 0.705604701696192 2.3861348671244675e-08 -0.09915166194682715 +1.7966000000000002 0.7056068006783571 0.7056051556311825 1.9875800108190567e-08 -0.09915191856331264 +1.7967 0.7056072557695823 0.705605609471841 1.587698857889036e-08 -0.09915217510250396 +1.7968000000000002 0.7056077106806065 0.7056060632183393 1.1865836875568636e-08 -0.09915243156442399 +1.7969000000000002 0.70560816541135 0.7056065168708396 7.843270362177523e-09 -0.09915268794909594 +1.797 0.705608619961743 0.705606970429494 3.810216747147932e-09 -0.09915294425654286 +1.7971000000000001 0.7056090743317256 0.7056074238944445 -2.323941265119922e-10 -0.0991532004867878 +1.7972000000000001 0.7056095285212478 0.7056078772658236 -4.283630493720492e-09 -0.09915345663985381 +1.7973000000000001 0.7056099825302695 0.705608330543753 -8.342558877223738e-09 -0.09915371271576391 +1.7974 0.7056104363587611 0.7056087837283451 -1.2408244313977246e-08 -0.09915396871454117 +1.7975 0.7056108900067026 0.705609236819702 -1.647975056374637e-08 -0.09915422463620865 +1.7976 0.705611343474084 0.7056096898179153 -2.0556140322477295e-08 -0.09915448048078933 +1.7977 0.7056117967609057 0.7056101427230672 -2.4636475442173233e-08 -0.09915473624830627 +1.7978000000000003 0.7056122498671777 0.7056105955352292 -2.8719817144265414e-08 -0.09915499193878244 +1.7979 0.7056127027929209 0.7056110482544634 -3.28052262379714e-08 -0.09915524755224091 +1.798 0.7056131555381651 0.7056115008808213 -3.6891763333882915e-08 -0.09915550308870463 +1.7981 0.7056136081029507 0.7056119534143446 -4.097848906015576e-08 -0.09915575854819664 +1.7982 0.7056140604873284 0.7056124058550646 -4.50644642796213e-08 -0.09915601393073985 +1.7983000000000002 0.7056145126913589 0.705612858203003 -4.914875030548847e-08 -0.09915626923635738 +1.7984 0.7056149647151124 0.7056133104581708 -5.323040911438953e-08 -0.09915652446507207 +1.7985 0.7056154165586697 0.7056137626205694 -5.730850356462994e-08 -0.0991567796169069 +1.7986000000000002 0.7056158682221214 0.7056142146901899 -6.138209761091459e-08 -0.09915703469188489 +1.7987 0.7056163197055678 0.7056146666670138 -6.545025652004988e-08 -0.09915728969002892 +1.7988000000000002 0.7056167710091202 0.7056151185510122 -6.951204707889361e-08 -0.099157544611362 +1.7989000000000002 0.7056172221328987 0.7056155703421463 -7.356653781726702e-08 -0.09915779945590704 +1.799 0.705617673077034 0.7056160220403673 -7.761279921698894e-08 -0.099158054223687 +1.7991000000000001 0.7056181238416666 0.7056164736456164 -8.164990392481308e-08 -0.09915830891472474 +1.7992000000000001 0.7056185744269466 0.7056169251578251 -8.56769269627633e-08 -0.09915856352904323 +1.7993000000000001 0.7056190248330347 0.7056173765769148 -8.969294594974447e-08 -0.09915881806666542 +1.7994 0.7056194750601008 0.7056178279027971 -9.369704129930101e-08 -0.09915907252761415 +1.7995 0.7056199251083246 0.7056182791353737 -9.768829643905935e-08 -0.09915932691191233 +1.7996 0.7056203749778958 0.7056187302745365 -1.0166579801716008e-07 -0.09915958121958285 +1.7997 0.7056208246690139 0.7056191813201679 -1.0562863611389417e-07 -0.0991598354506486 +1.7998000000000003 0.7056212741818882 0.7056196322721403 -1.0957590444466564e-07 -0.0991600896051325 +1.7999 0.7056217235167374 0.7056200831303167 -1.1350670056989309e-07 -0.09916034368305746 +1.8 0.7056221726737897 0.7056205338945498 -1.1742012610317654e-07 -0.0991605976844462 +1.8001 0.7056226216532829 0.7056209845646834 -1.2131528692206628e-07 -0.09916085160932167 +1.8002 0.7056230704554647 0.7056214351405514 -1.251912933545457e-07 -0.09916110545770668 +1.8003000000000002 0.7056235190805922 0.7056218856219787 -1.2904726040020853e-07 -0.09916135922962417 +1.8004 0.7056239675289318 0.7056223360087802 -1.328823079158742e-07 -0.09916161292509694 +1.8005 0.7056244158007587 0.7056227863007615 -1.3669556083242829e-07 -0.09916186654414778 +1.8006000000000002 0.7056248638963583 0.7056232364977191 -1.404861493543158e-07 -0.09916212008679953 +1.8007 0.7056253118160245 0.7056236865994399 -1.442532091451565e-07 -0.099162373553075 +1.8008000000000002 0.705625759560061 0.7056241366057017 -1.4799588152376864e-07 -0.09916262694299699 +1.8009000000000002 0.7056262071287807 0.7056245865162737 -1.517133136740706e-07 -0.09916288025658837 +1.801 0.7056266545225047 0.7056250363309154 -1.5540465883243093e-07 -0.09916313349387192 +1.8011000000000001 0.7056271017415638 0.7056254860493774 -1.5906907646981439e-07 -0.09916338665487039 +1.8012000000000001 0.7056275487862976 0.7056259356714012 -1.6270573251729592e-07 -0.09916363973960658 +1.8013000000000001 0.7056279956570544 0.7056263851967199 -1.6631379950136915e-07 -0.09916389274810328 +1.8014000000000001 0.7056284423541912 0.7056268346250573 -1.6989245678507292e-07 -0.0991641456803832 +1.8015 0.7056288888780742 0.705627283956129 -1.734408907241164e-07 -0.09916439853646922 +1.8016 0.7056293352290777 0.7056277331896417 -1.7695829486463754e-07 -0.09916465131638405 +1.8017 0.7056297814075847 0.7056281823252932 -1.8044387010973661e-07 -0.09916490402015044 +1.8018000000000003 0.7056302274139867 0.7056286313627733 -1.8389682491376513e-07 -0.09916515664779109 +1.8019 0.7056306732486836 0.7056290803017629 -1.8731637548355384e-07 -0.09916540919932877 +1.802 0.7056311189120835 0.7056295291419353 -1.9070174591545586e-07 -0.09916566167478624 +1.8021 0.705631564404603 0.7056299778829549 -1.9405216838616623e-07 -0.09916591407418618 +1.8022 0.7056320097266661 0.7056304265244783 -1.9736688333660268e-07 -0.0991661663975513 +1.8023000000000002 0.7056324548787059 0.7056308750661542 -2.0064513965231678e-07 -0.09916641864490441 +1.8024 0.7056328998611625 0.7056313235076228 -2.0388619479186354e-07 -0.09916667081626815 +1.8025 0.7056333446744842 0.705631771848517 -2.0708931499149874e-07 -0.09916692291166522 +1.8026000000000002 0.7056337893191273 0.7056322200884615 -2.1025377542477353e-07 -0.09916717493111832 +1.8027 0.705634233795555 0.7056326682270733 -2.1337886037253728e-07 -0.09916742687465009 +1.8028000000000002 0.705634678104239 0.7056331162639622 -2.1646386336171553e-07 -0.09916767874228323 +1.8029000000000002 0.7056351222456577 0.7056335641987306 -2.195080873422517e-07 -0.09916793053404048 +1.803 0.7056355662202973 0.7056340120309728 -2.225108448467017e-07 -0.09916818224994439 +1.8031000000000001 0.7056360100286512 0.7056344597602764 -2.2547145814635905e-07 -0.09916843389001771 +1.8032000000000001 0.7056364536712194 0.7056349073862225 -2.2838925938309385e-07 -0.0991686854542831 +1.8033000000000001 0.7056368971485096 0.7056353549083838 -2.3126359072547786e-07 -0.09916893694276319 +1.8034000000000001 0.7056373404610361 0.7056358023263267 -2.3409380454572637e-07 -0.09916918835548058 +1.8035 0.7056377836093197 0.7056362496396107 -2.368792635445982e-07 -0.09916943969245785 +1.8036 0.7056382265938889 0.7056366968477887 -2.396193408936431e-07 -0.09916969095371776 +1.8037 0.7056386694152775 0.7056371439504072 -2.423134203705102e-07 -0.09916994213928286 +1.8038000000000003 0.7056391120740266 0.7056375909470055 -2.44960896508134e-07 -0.09917019324917574 +1.8039 0.7056395545706835 0.7056380378371174 -2.475611747404516e-07 -0.09917044428341905 +1.804 0.7056399969058016 0.7056384846202695 -2.50113671509955e-07 -0.09917069524203534 +1.8041 0.7056404390799402 0.705638931295983 -2.526178144238167e-07 -0.0991709461250472 +1.8042 0.7056408810936653 0.7056393778637733 -2.550730423510339e-07 -0.09917119693247728 +1.8043000000000002 0.7056413229475482 0.7056398243231492 -2.5747880558549263e-07 -0.0991714476643482 +1.8044 0.7056417646421659 0.705640270673614 -2.598345659604595e-07 -0.09917169832068243 +1.8045 0.7056422061781011 0.7056407169146652 -2.621397969249095e-07 -0.09917194890150254 +1.8046000000000002 0.7056426475559423 0.7056411630457955 -2.643939837239373e-07 -0.09917219940683113 +1.8047 0.705643088776283 0.705641609066491 -2.665966234646766e-07 -0.09917244983669073 +1.8048000000000002 0.705643529839722 0.7056420549762334 -2.6874722527242545e-07 -0.09917270019110386 +1.8049000000000002 0.705643970746863 0.7056425007744997 -2.7084531036350445e-07 -0.0991729504700931 +1.805 0.7056444114983152 0.7056429464607608 -2.7289041215974863e-07 -0.09917320067368096 +1.8051000000000001 0.7056448520946925 0.7056433920344832 -2.7488207639952966e-07 -0.09917345080188998 +1.8052000000000001 0.7056452925366131 0.705643837495129 -2.768198612453088e-07 -0.09917370085474268 +1.8053000000000001 0.7056457328247001 0.7056442828421552 -2.7870333736690345e-07 -0.09917395083226156 +1.8054000000000001 0.7056461729595812 0.7056447280750149 -2.805320880282236e-07 -0.09917420073446914 +1.8055 0.7056466129418878 0.7056451731931561 -2.823057092295189e-07 -0.0991744505613879 +1.8056 0.7056470527722563 0.7056456181960233 -2.8402380970737884e-07 -0.0991747003130404 +1.8057 0.7056474924513261 0.7056460630830566 -2.856860111220827e-07 -0.09917494998944901 +1.8058 0.7056479319797413 0.7056465078536922 -2.8729194808188585e-07 -0.09917519959063631 +1.8059 0.7056483713581497 0.7056469525073629 -2.888412682020003e-07 -0.09917544911662468 +1.806 0.7056488105872025 0.7056473970434975 -2.903336322572503e-07 -0.09917569856743674 +1.8061 0.7056492496675542 0.7056478414615217 -2.9176871415778627e-07 -0.09917594794309485 +1.8062 0.7056496885998629 0.7056482857608571 -2.931462011329655e-07 -0.09917619724362149 +1.8063000000000002 0.7056501273847895 0.7056487299409226 -2.944657936966577e-07 -0.09917644646903905 +1.8064 0.7056505660229986 0.705649174001134 -2.957272057756144e-07 -0.09917669561937 +1.8065 0.7056510045151568 0.7056496179409044 -2.969301647545719e-07 -0.09917694469463678 +1.8066000000000002 0.7056514428619345 0.705650061759644 -2.980744115317624e-07 -0.09917719369486185 +1.8067 0.7056518810640036 0.7056505054567599 -2.991597005605473e-07 -0.09917744262006757 +1.8068000000000002 0.7056523191220394 0.7056509490316571 -3.0018579992921457e-07 -0.09917769147027639 +1.8069000000000002 0.7056527570367188 0.7056513924837386 -3.0115249139567313e-07 -0.09917794024551069 +1.807 0.7056531948087215 0.7056518358124051 -3.020595704394946e-07 -0.09917818894579289 +1.8071000000000002 0.7056536324387286 0.7056522790170544 -3.0290684628619946e-07 -0.09917843757114542 +1.8072000000000001 0.7056540699274234 0.7056527220970834 -3.0369414197317646e-07 -0.09917868612159059 +1.8073000000000001 0.7056545072754907 0.7056531650518872 -3.044212943809077e-07 -0.09917893459715083 +1.8074000000000001 0.7056549444836173 0.7056536078808586 -3.0508815423296864e-07 -0.09917918299784849 +1.8075 0.7056553815524909 0.7056540505833897 -3.056945861723559e-07 -0.09917943132370594 +1.8076 0.7056558184828007 0.705654493158871 -3.0624046878230393e-07 -0.09917967957474556 +1.8077 0.7056562552752373 0.7056549356066917 -3.0672569459322396e-07 -0.09917992775098972 +1.8078 0.7056566919304919 0.7056553779262402 -3.0715017007576506e-07 -0.09918017585246075 +1.8079 0.7056571284492565 0.7056558201169041 -3.07513815717142e-07 -0.09918042387918097 +1.808 0.7056575648322239 0.7056562621780704 -3.078165659933796e-07 -0.09918067183117273 +1.8081 0.7056580010800875 0.7056567041091251 -3.080583694387018e-07 -0.09918091970845838 +1.8082 0.7056584371935408 0.7056571459094543 -3.0823918855532595e-07 -0.09918116751106021 +1.8083000000000002 0.705658873173278 0.7056575875784437 -3.083589998620351e-07 -0.09918141523900056 +1.8084 0.7056593090199927 0.7056580291154787 -3.0841779396356683e-07 -0.09918166289230175 +1.8085 0.705659744734379 0.7056584705199449 -3.08415575453469e-07 -0.09918191047098601 +1.8086000000000002 0.7056601803171305 0.7056589117912282 -3.0835236297654944e-07 -0.09918215797507572 +1.8087 0.7056606157689405 0.705659352928715 -3.0822818915254846e-07 -0.09918240540459311 +1.8088000000000002 0.7056610510905015 0.7056597939317919 -3.0804310060389417e-07 -0.09918265275956051 +1.8089000000000002 0.7056614862825059 0.7056602347998462 -3.077971579695804e-07 -0.09918290004000019 +1.809 0.7056619213456443 0.7056606755322657 -3.0749043583577773e-07 -0.0991831472459343 +1.8091000000000002 0.7056623562806075 0.7056611161284403 -3.0712302274277237e-07 -0.09918339437738527 +1.8092000000000001 0.7056627910880842 0.7056615565877594 -3.06695021129455e-07 -0.09918364143437522 +1.8093000000000001 0.7056632257687627 0.7056619969096152 -3.0620654736801534e-07 -0.09918388841692649 +1.8094000000000001 0.7056636603233291 0.7056624370934005 -3.0565773165985854e-07 -0.09918413532506133 +1.8095 0.7056640947524682 0.7056628771385096 -3.050487180425443e-07 -0.09918438215880195 +1.8096 0.705664529056863 0.7056633170443387 -3.043796643759089e-07 -0.09918462891817058 +1.8097 0.7056649632371952 0.7056637568102857 -3.0365074222410415e-07 -0.09918487560318943 +1.8098 0.7056653972941435 0.7056641964357508 -3.028621369111084e-07 -0.09918512221388076 +1.8099 0.705665831228385 0.705664635920136 -3.020140473958266e-07 -0.09918536875026673 +1.81 0.7056662650405946 0.7056650752628459 -3.011066862304568e-07 -0.09918561521236959 +1.8101 0.7056666987314446 0.7056655144632871 -3.001402795639596e-07 -0.09918586160021152 +1.8102 0.7056671323016045 0.7056659535208691 -2.991150670171583e-07 -0.09918610791381466 +1.8103000000000002 0.7056675657517412 0.7056663924350044 -2.980313016688607e-07 -0.09918635415320129 +1.8104 0.7056679990825186 0.7056668312051078 -2.968892500003484e-07 -0.09918660031839353 +1.8105 0.7056684322945981 0.7056672698305974 -2.956891917808846e-07 -0.09918684640941355 +1.8106000000000002 0.7056688653886372 0.7056677083108942 -2.944314200364895e-07 -0.09918709242628354 +1.8107 0.7056692983652905 0.7056681466454228 -2.9311624095626487e-07 -0.09918733836902564 +1.8108000000000002 0.7056697312252088 0.7056685848336111 -2.917439738576999e-07 -0.09918758423766195 +1.8109000000000002 0.7056701639690399 0.7056690228748903 -2.903149510791181e-07 -0.09918783003221468 +1.811 0.7056705965974273 0.7056694607686963 -2.88829517906819e-07 -0.09918807575270597 +1.8111000000000002 0.7056710291110111 0.7056698985144678 -2.8728803246058643e-07 -0.09918832139915798 +1.8112000000000001 0.705671461510427 0.7056703361116476 -2.856908656867496e-07 -0.09918856697159276 +1.8113000000000001 0.7056718937963067 0.7056707735596831 -2.840384011777719e-07 -0.09918881247003247 +1.8114000000000001 0.7056723259692776 0.7056712108580256 -2.823310351375563e-07 -0.09918905789449922 +1.8115 0.7056727580299629 0.7056716480061309 -2.8056917626695377e-07 -0.09918930324501514 +1.8116 0.7056731899789807 0.7056720850034596 -2.7875324568396587e-07 -0.09918954852160229 +1.8117 0.7056736218169449 0.7056725218494763 -2.7688367679190584e-07 -0.09918979372428278 +1.8118 0.7056740535444647 0.7056729585436508 -2.749609151996013e-07 -0.0991900388530787 +1.8119 0.7056744851621437 0.7056733950854575 -2.7298541859649417e-07 -0.09919028390801204 +1.812 0.7056749166705812 0.7056738314743765 -2.709576566797822e-07 -0.09919052888910497 +1.8121 0.7056753480703712 0.7056742677098926 -2.688781110156413e-07 -0.09919077379637958 +1.8122 0.7056757793621019 0.7056747037914961 -2.667472749177946e-07 -0.09919101862985791 +1.8123000000000002 0.7056762105463563 0.7056751397186822 -2.6456565334689874e-07 -0.09919126338956195 +1.8124 0.7056766416237119 0.7056755754909527 -2.623337628029909e-07 -0.09919150807551386 +1.8125 0.7056770725947403 0.705676011107814 -2.600521311416082e-07 -0.09919175268773563 +1.8126000000000002 0.7056775034600078 0.7056764465687787 -2.5772129756337914e-07 -0.09919199722624923 +1.8127 0.7056779342200741 0.7056768818733654 -2.553418123572848e-07 -0.0991922416910768 +1.8128000000000002 0.7056783648754932 0.7056773170210981 -2.52914236848617e-07 -0.09919248608224024 +1.8129000000000002 0.7056787954268131 0.7056777520115078 -2.50439143256731e-07 -0.09919273039976162 +1.813 0.7056792258745752 0.7056781868441319 -2.4791711455973697e-07 -0.09919297464366299 +1.8131000000000002 0.7056796562193149 0.7056786215185132 -2.4534874434531395e-07 -0.09919321881396637 +1.8132000000000001 0.7056800864615607 0.7056790560342014 -2.4273463665805406e-07 -0.09919346291069366 +1.8133000000000001 0.7056805166018345 0.7056794903907533 -2.4007540589884857e-07 -0.09919370693386693 +1.8134000000000001 0.705680946640652 0.7056799245877314 -2.3737167664794612e-07 -0.09919395088350814 +1.8135 0.705681376578521 0.7056803586247056 -2.3462408352964426e-07 -0.09919419475963921 +1.8136 0.7056818064159435 0.705680792501253 -2.318332710526949e-07 -0.0991944385622822 +1.8137 0.7056822361534139 0.7056812262169574 -2.2899989349234318e-07 -0.099194682291459 +1.8138 0.7056826657914195 0.7056816597714095 -2.2612461469256884e-07 -0.09919492594719163 +1.8139 0.7056830953304407 0.7056820931642076 -2.2320810793771684e-07 -0.09919516952950204 +1.814 0.7056835247709499 0.7056825263949571 -2.202510557998416e-07 -0.09919541303841214 +1.8141 0.7056839541134126 0.705682959463271 -2.172541499478875e-07 -0.0991956564739439 +1.8142 0.7056843833582864 0.7056833923687691 -2.1421809101238032e-07 -0.09919589983611915 +1.8143000000000002 0.7056848125060216 0.70568382511108 -2.111435884258328e-07 -0.0991961431249599 +1.8144 0.7056852415570607 0.7056842576898392 -2.0803136024580282e-07 -0.0991963863404881 +1.8145 0.7056856705118382 0.7056846901046905 -2.0488213297795155e-07 -0.09919662948272562 +1.8146000000000002 0.705686099370781 0.7056851223552847 -2.0169664142338783e-07 -0.09919687255169436 +1.8147 0.7056865281343077 0.7056855544412816 -1.9847562849131806e-07 -0.09919711554741627 +1.8148000000000002 0.7056869568028286 0.7056859863623481 -1.9521984504639045e-07 -0.09919735846991312 +1.8149000000000002 0.7056873853767467 0.7056864181181601 -1.9193004971787553e-07 -0.09919760131920691 +1.815 0.705687813856456 0.7056868497084012 -1.8860700873660208e-07 -0.09919784409531948 +1.8151000000000002 0.7056882422423426 0.7056872811327638 -1.8525149573719868e-07 -0.09919808679827276 +1.8152000000000001 0.705688670534784 0.7056877123909479 -1.818642915950297e-07 -0.09919832942808855 +1.8153000000000001 0.7056890987341491 0.7056881434826623 -1.7844618423537573e-07 -0.09919857198478871 +1.8154000000000001 0.7056895268407983 0.7056885744076243 -1.7499796845649174e-07 -0.09919881446839507 +1.8155 0.7056899548550841 0.7056890051655602 -1.715204457353181e-07 -0.09919905687892955 +1.8156 0.7056903827773493 0.7056894357562046 -1.6801442405400824e-07 -0.09919929921641402 +1.8157 0.7056908106079286 0.7056898661793007 -1.6448071770043537e-07 -0.09919954148087023 +1.8158 0.7056912383471474 0.7056902964346007 -1.6092014708778135e-07 -0.09919978367232005 +1.8159 0.7056916659953225 0.7056907265218655 -1.5733353856545174e-07 -0.09920002579078524 +1.816 0.705692093552762 0.7056911564408651 -1.537217242178479e-07 -0.09920026783628771 +1.8161 0.7056925210197644 0.7056915861913784 -1.5008554168048638e-07 -0.0992005098088492 +1.8162 0.7056929483966201 0.7056920157731933 -1.4642583394917918e-07 -0.09920075170849159 +1.8163000000000002 0.7056933756836092 0.7056924451861069 -1.4274344915105042e-07 -0.09920099353523662 +1.8164 0.7056938028810031 0.7056928744299251 -1.3903924039881943e-07 -0.09920123528910603 +1.8165 0.7056942299890645 0.7056933035044637 -1.3531406556181735e-07 -0.09920147697012172 +1.8166000000000002 0.7056946570080462 0.7056937324095469 -1.3156878707863695e-07 -0.09920171857830538 +1.8167 0.7056950839381919 0.7056941611450089 -1.2780427174723108e-07 -0.09920196011367882 +1.8168000000000002 0.7056955107797361 0.7056945897106925 -1.2402139053756256e-07 -0.09920220157626376 +1.8169000000000002 0.7056959375329035 0.7056950181064505 -1.2022101836955956e-07 -0.09920244296608198 +1.817 0.7056963641979099 0.7056954463321452 -1.1640403393964327e-07 -0.09920268428315529 +1.8171000000000002 0.7056967907749612 0.705695874387648 -1.1257131949868326e-07 -0.09920292552750537 +1.8172000000000001 0.7056972172642537 0.7056963022728396 -1.0872376064383071e-07 -0.099203166699154 +1.8173000000000001 0.7056976436659748 0.7056967299876105 -1.0486224613463768e-07 -0.09920340779812284 +1.8174000000000001 0.7056980699803016 0.7056971575318608 -1.0098766766667572e-07 -0.09920364882443368 +1.8175 0.705698496207402 0.7056975849055003 -9.710091968071627e-08 -0.09920388977810825 +1.8176 0.7056989223474344 0.705698012108448 -9.32028991424208e-08 -0.09920413065916824 +1.8177 0.7056993484005468 0.7056984391406325 -8.929450535152123e-08 -0.09920437146763533 +1.8178 0.7056997743668783 0.7056988660019927 -8.537663971890791e-08 -0.09920461220353122 +1.8179 0.7057002002465582 0.7056992926924769 -8.145020557147331e-08 -0.09920485286687769 +1.818 0.705700626039706 0.7056997192120429 -7.751610793613889e-08 -0.09920509345769639 +1.8181 0.7057010517464308 0.705700145560658 -7.357525333255566e-08 -0.09920533397600893 +1.8182 0.7057014773668329 0.7057005717382998 -6.962854956797312e-08 -0.09920557442183706 +1.8183000000000002 0.7057019029010025 0.7057009977449551 -6.567690552256727e-08 -0.09920581479520241 +1.8184 0.7057023283490201 0.7057014235806212 -6.172123094691159e-08 -0.0992060550961267 +1.8185 0.7057027537109559 0.7057018492453038 -5.776243624253455e-08 -0.09920629532463146 +1.8186000000000002 0.7057031789868711 0.70570227473902 -5.380143226546216e-08 -0.09920653548073848 +1.8187 0.7057036041768168 0.7057027000617955 -4.983913010785969e-08 -0.09920677556446933 +1.8188000000000002 0.7057040292808343 0.7057031252136663 -4.587644089008164e-08 -0.09920701557584567 +1.8189000000000002 0.7057044542989548 0.7057035501946778 -4.1914275552586274e-08 -0.09920725551488913 +1.819 0.7057048792312002 0.7057039750048856 -3.795354464541066e-08 -0.09920749538162131 +1.8191000000000002 0.7057053040775827 0.7057043996443546 -3.399515811994963e-08 -0.0992077351760639 +1.8192000000000002 0.7057057288381041 0.7057048241131596 -3.004002511975898e-08 -0.0992079748982384 +1.8193000000000001 0.7057061535127573 0.7057052484113852 -2.6089053770843654e-08 -0.09920821454816653 +1.8194000000000001 0.7057065781015247 0.7057056725391253 -2.2143150973843312e-08 -0.09920845412586976 +1.8195 0.7057070026043797 0.7057060964964845 -1.8203222199985464e-08 -0.09920869363136983 +1.8196 0.7057074270212852 0.7057065202835757 -1.4270171274678722e-08 -0.09920893306468821 +1.8197 0.7057078513521952 0.7057069439005227 -1.034490017650172e-08 -0.09920917242584655 +1.8198 0.7057082755970534 0.7057073673474579 -6.428308829686813e-09 -0.09920941171486637 +1.8199 0.7057086997557942 0.7057077906245244 -2.5212948976879868e-09 -0.09920965093176926 +1.82 0.7057091238283424 0.7057082137318738 1.3752464254196406e-09 -0.09920989007657677 +1.8201 0.7057095478146134 0.7057086366696681 5.2604226148667e-09 -0.0992101291493105 +1.8202 0.7057099717145126 0.7057090594380783 9.133344023790069e-09 -0.099210368149992 +1.8203000000000003 0.7057103955279358 0.7057094820372849 1.2993124084460794e-08 -0.09921060707864268 +1.8204 0.7057108192547701 0.7057099044674782 1.6838879512114102e-08 -0.0992108459352842 +1.8205 0.7057112428948926 0.705710326728858 2.0669730509646767e-08 -0.09921108471993811 +1.8206000000000002 0.7057116664481708 0.7057107488216326 2.448480095756933e-08 -0.0992113234326258 +1.8207 0.7057120899144635 0.7057111707460209 2.8283218633448626e-08 -0.09921156207336893 +1.8208000000000002 0.7057125132936197 0.7057115925022501 3.206411539578846e-08 -0.09921180064218896 +1.8209000000000002 0.7057129365854793 0.7057120140905571 3.582662738525755e-08 -0.0992120391391074 +1.821 0.7057133597898727 0.7057124355111879 3.9569895225050056e-08 -0.09921227756414569 +1.8211000000000002 0.7057137829066218 0.7057128567643974 4.329306422211354e-08 -0.09921251591732544 +1.8212000000000002 0.7057142059355386 0.70571327785045 4.6995284549294913e-08 -0.099212754198668 +1.8213000000000001 0.7057146288764264 0.7057136987696186 5.0675711444833627e-08 -0.09921299240819491 +1.8214000000000001 0.7057150517290796 0.7057141195221859 5.433350541185489e-08 -0.09921323054592762 +1.8215 0.7057154744932834 0.705714540108443 5.796783240051562e-08 -0.09921346861188762 +1.8216 0.7057158971688144 0.7057149605286896 6.15778640040282e-08 -0.09921370660609637 +1.8217 0.7057163197554401 0.7057153807832349 6.516277764774536e-08 -0.0992139445285753 +1.8218 0.7057167422529196 0.7057158008723964 6.872175675916303e-08 -0.0992141823793459 +1.8219 0.7057171646610029 0.7057162207965001 7.225399099169971e-08 -0.09921442015842957 +1.822 0.7057175869794317 0.7057166405558809 7.575867636347433e-08 -0.09921465786584777 +1.8221 0.7057180092079389 0.7057170601508822 7.923501548108558e-08 -0.09921489550162194 +1.8222 0.7057184313462491 0.7057174795818559 8.268221769053286e-08 -0.09921513306577345 +1.8223000000000003 0.7057188533940784 0.7057178988491621 8.609949927324001e-08 -0.09921537055832376 +1.8224 0.7057192753511345 0.7057183179531696 8.94860836264666e-08 -0.09921560797929431 +1.8225 0.7057196972171169 0.7057187368942546 9.28412014211677e-08 -0.09921584532870639 +1.8226000000000002 0.7057201189917174 0.7057191556728022 9.616409079454824e-08 -0.09921608260658152 +1.8227 0.7057205406746188 0.705719574289205 9.945399753394368e-08 -0.09921631981294095 +1.8228000000000002 0.7057209622654966 0.7057199927438642 1.0271017519131176e-07 -0.09921655694780614 +1.8229000000000002 0.7057213837640184 0.7057204110371889 1.0593188533303266e-07 -0.09921679401119854 +1.823 0.7057218051698435 0.7057208291695951 1.0911839763705355e-07 -0.0992170310031394 +1.8231000000000002 0.7057222264826236 0.705721247141508 1.122689901010554e-07 -0.0992172679236502 +1.8232000000000002 0.7057226477020031 0.7057216649533588 1.153829492089864e-07 -0.09921750477275221 +1.8233000000000001 0.7057230688276187 0.7057220826055872 1.184595700420843e-07 -0.09921774155046685 +1.8234000000000001 0.7057234898590992 0.7057225000986402 1.2149815649745155e-07 -0.09921797825681541 +1.8235 0.7057239107960664 0.705722917432972 1.2449802142336375e-07 -0.09921821489181923 +1.8236 0.7057243316381351 0.7057233346090439 1.274584867511086e-07 -0.09921845145549964 +1.8237 0.7057247523849124 0.7057237516273251 1.3037888368233608e-07 -0.09921868794787803 +1.8238 0.7057251730359987 0.7057241684882908 1.3325855283824461e-07 -0.09921892436897563 +1.8239 0.7057255935909872 0.7057245851924238 1.3609684437407288e-07 -0.09921916071881381 +1.824 0.7057260140494648 0.7057250017402138 1.3889311816991934e-07 -0.09921939699741394 +1.8241 0.7057264344110102 0.7057254181321568 1.416467439278868e-07 -0.09921963320479718 +1.8242 0.7057268546751975 0.7057258343687557 1.4435710136290192e-07 -0.09921986934098495 +1.8243000000000003 0.7057272748415926 0.7057262504505197 1.470235803102682e-07 -0.09922010540599846 +1.8244 0.7057276949097557 0.7057266663779652 1.4964558086097424e-07 -0.09922034139985908 +1.8245 0.7057281148792407 0.7057270821516135 1.522225135386357e-07 -0.09922057732258799 +1.8246000000000002 0.705728534749595 0.7057274977719932 1.54753799375823e-07 -0.09922081317420652 +1.8247 0.7057289545203602 0.7057279132396385 1.57238870073656e-07 -0.09922104895473592 +1.8248000000000002 0.7057293741910716 0.7057283285550896 1.5967716813364285e-07 -0.09922128466419743 +1.8249000000000002 0.705729793761259 0.7057287437188927 1.6206814695135519e-07 -0.0992215203026123 +1.825 0.7057302132304466 0.7057291587315997 1.6441127098643094e-07 -0.09922175587000186 +1.8251000000000002 0.7057306325981523 0.7057295735937676 1.6670601583196332e-07 -0.09922199136638722 +1.8252000000000002 0.7057310518638888 0.7057299883059597 1.689518683914426e-07 -0.09922222679178971 +1.8253000000000001 0.7057314710271638 0.7057304028687439 1.711483269342673e-07 -0.09922246214623051 +1.8254000000000001 0.7057318900874794 0.7057308172826939 1.732949012310525e-07 -0.09922269742973085 +1.8255 0.7057323090443327 0.7057312315483883 1.7539111268199958e-07 -0.09922293264231197 +1.8256000000000001 0.7057327278972154 0.7057316456664103 1.7743649439322384e-07 -0.09922316778399502 +1.8257 0.7057331466456152 0.7057320596373486 1.7943059129471584e-07 -0.09922340285480129 +1.8258 0.705733565289014 0.7057324734617962 1.8137296023748584e-07 -0.09922363785475186 +1.8259 0.7057339838268901 0.7057328871403507 1.832631701011167e-07 -0.09922387278386806 +1.826 0.7057344022587166 0.7057333006736142 1.851008018839695e-07 -0.09922410764217093 +1.8261 0.7057348205839625 0.7057337140621933 1.8688544877604185e-07 -0.09922434242968176 +1.8262 0.7057352388020928 0.7057341273066988 1.8861671627345977e-07 -0.09922457714642173 +1.8263000000000003 0.7057356569125678 0.7057345404077454 1.902942222756221e-07 -0.0992248117924119 +1.8264 0.7057360749148444 0.7057349533659516 1.919175971580589e-07 -0.09922504636767349 +1.8265 0.7057364928083752 0.70573536618194 1.9348648380712596e-07 -0.09922528087222764 +1.8266000000000002 0.7057369105926099 0.7057357788563369 1.9500053779347715e-07 -0.09922551530609552 +1.8267 0.7057373282669938 0.7057361913897716 1.9645942735124766e-07 -0.09922574966929822 +1.8268000000000002 0.705737745830969 0.7057366037828776 1.9786283352030143e-07 -0.0992259839618569 +1.8269000000000002 0.7057381632839748 0.705737016036291 1.9921045018786443e-07 -0.09922621818379271 +1.827 0.705738580625447 0.7057374281506512 2.0050198412321918e-07 -0.09922645233512677 +1.8271000000000002 0.7057389978548183 0.7057378401266007 2.017371551095437e-07 -0.09922668641588016 +1.8272 0.7057394149715188 0.7057382519647846 2.0291569597166714e-07 -0.09922692042607399 +1.8273000000000001 0.7057398319749758 0.7057386636658511 2.0403735261423361e-07 -0.09922715436572943 +1.8274000000000001 0.7057402488646138 0.7057390752304504 2.0510188408762176e-07 -0.09922738823486749 +1.8275 0.7057406656398553 0.7057394866592356 2.0610906266774198e-07 -0.09922762203350932 +1.8276000000000001 0.7057410823001198 0.7057398979528615 2.0705867385256704e-07 -0.0992278557616759 +1.8277 0.7057414988448256 0.7057403091119857 2.0795051647662377e-07 -0.09922808941938843 +1.8278 0.7057419152733881 0.7057407201372675 2.0878440266589027e-07 -0.09922832300666795 +1.8279 0.705742331585222 0.7057411310293682 2.095601579696349e-07 -0.09922855652353554 +1.828 0.7057427477797389 0.7057415417889502 2.1027762132225236e-07 -0.09922878997001226 +1.8281 0.7057431638563494 0.7057419524166779 2.1093664510571375e-07 -0.09922902334611908 +1.8282 0.705743579814463 0.7057423629132173 2.1153709520507769e-07 -0.09922925665187711 +1.8283000000000003 0.7057439956534877 0.7057427732792353 2.1207885097379586e-07 -0.09922948988730741 +1.8284 0.7057444113728301 0.7057431835153999 2.1256180532391866e-07 -0.09922972305243097 +1.8285 0.7057448269718961 0.7057435936223803 2.1298586471221737e-07 -0.09922995614726883 +1.8286000000000002 0.7057452424500905 0.7057440036008464 2.1335094914712305e-07 -0.099230189171842 +1.8287 0.705745657806818 0.7057444134514692 2.1365699220954326e-07 -0.09923042212617154 +1.8288000000000002 0.705746073041482 0.7057448231749193 2.139039411014343e-07 -0.09923065501027845 +1.8289000000000002 0.7057464881534857 0.7057452327718686 2.1409175661457613e-07 -0.0992308878241837 +1.829 0.7057469031422324 0.7057456422429887 2.1422041314098084e-07 -0.09923112056790828 +1.8291000000000002 0.7057473180071249 0.7057460515889518 2.1428989869023973e-07 -0.09923135324147325 +1.8292 0.7057477327475661 0.7057464608104294 2.1430021484789008e-07 -0.09923158584489956 +1.8293000000000001 0.7057481473629591 0.7057468699080931 2.1425137684133455e-07 -0.09923181837820816 +1.8294000000000001 0.7057485618527073 0.7057472788826145 2.141434134635134e-07 -0.09923205084142002 +1.8295 0.7057489762162149 0.705747687734664 2.1397636710412948e-07 -0.09923228323455616 +1.8296000000000001 0.705749390452886 0.7057480964649123 2.1375029370454546e-07 -0.0992325155576375 +1.8297 0.7057498045621262 0.7057485050740284 2.13465262775131e-07 -0.09923274781068502 +1.8298 0.7057502185433414 0.7057489135626807 2.1312135737444615e-07 -0.0992329799937196 +1.8299 0.7057506323959389 0.7057493219315372 2.127186740225051e-07 -0.09923321210676228 +1.83 0.7057510461193273 0.7057497301812632 2.1225732278057352e-07 -0.09923344414983391 +1.8301 0.705751459712916 0.7057501383125244 2.1173742711239063e-07 -0.09923367612295549 +1.8302 0.7057518731761161 0.7057505463259836 2.1115912392927205e-07 -0.09923390802614789 +1.8303000000000003 0.705752286508341 0.7057509542223028 2.1052256352072085e-07 -0.09923413985943207 +1.8304 0.7057526997090049 0.7057513620021417 2.098279095370803e-07 -0.09923437162282889 +1.8305 0.7057531127775244 0.7057517696661585 2.0907533894096164e-07 -0.0992346033163593 +1.8306000000000002 0.7057535257133178 0.705752177215009 2.0826504191356898e-07 -0.09923483494004418 +1.8307 0.7057539385158063 0.7057525846493469 2.0739722188592435e-07 -0.09923506649390444 +1.8308000000000002 0.7057543511844124 0.7057529919698236 2.0647209546947876e-07 -0.09923529797796092 +1.8309000000000002 0.7057547637185624 0.7057533991770878 2.0548989232774262e-07 -0.09923552939223454 +1.831 0.7057551761176837 0.7057538062717859 2.0445085521444972e-07 -0.09923576073674616 +1.8311000000000002 0.7057555883812074 0.7057542132545613 2.0335523988335158e-07 -0.09923599201151666 +1.8312 0.7057560005085677 0.7057546201260547 2.022033150188285e-07 -0.09923622321656692 +1.8313000000000001 0.7057564124992008 0.7057550268869033 2.0099536215262281e-07 -0.0992364543519177 +1.8314000000000001 0.7057568243525473 0.7057554335377414 1.9973167561179728e-07 -0.09923668541758995 +1.8315 0.7057572360680499 0.7057558400792001 1.9841256245628491e-07 -0.09923691641360446 +1.8316000000000001 0.7057576476451559 0.7057562465119069 1.9703834240603069e-07 -0.09923714733998214 +1.8317 0.7057580590833152 0.7057566528364858 1.9560934774731642e-07 -0.09923737819674373 +1.8318 0.7057584703819819 0.7057570590535571 1.9412592324602462e-07 -0.09923760898391015 +1.8319 0.705758881540614 0.7057574651637369 1.925884260886579e-07 -0.09923783970150214 +1.832 0.7057592925586731 0.7057578711676374 1.909972257990722e-07 -0.09923807034954052 +1.8321 0.7057597034356252 0.7057582770658672 1.8935270413092398e-07 -0.09923830092804614 +1.8322 0.7057601141709403 0.7057586828590301 1.876552549705257e-07 -0.09923853143703971 +1.8323000000000003 0.705760524764093 0.7057590885477256 1.859052842743958e-07 -0.09923876187654213 +1.8324 0.7057609352145625 0.7057594941325489 1.8410320993395013e-07 -0.09923899224657415 +1.8325 0.7057613455218321 0.7057598996140906 1.8224946169917433e-07 -0.09923922254715656 +1.8326000000000002 0.7057617556853903 0.7057603049929362 1.8034448106760137e-07 -0.09923945277831012 +1.8327 0.7057621657047303 0.7057607102696664 1.7838872121492266e-07 -0.09923968294005561 +1.8328000000000002 0.7057625755793503 0.705761115444857 1.7638264681804627e-07 -0.09923991303241378 +1.8329000000000002 0.7057629853087535 0.7057615205190786 1.7432673402040244e-07 -0.09924014305540539 +1.833 0.7057633948924485 0.705761925492897 1.72221470241124e-07 -0.0992403730090512 +1.8331000000000002 0.7057638043299493 0.7057623303668717 1.7006735410912688e-07 -0.09924060289337196 +1.8332 0.7057642136207751 0.7057627351415576 1.6786489533821003e-07 -0.0992408327083884 +1.8333000000000002 0.7057646227644512 0.7057631398175033 1.65614614622972e-07 -0.09924106245412125 +1.8334000000000001 0.7057650317605078 0.7057635443952521 1.633170435104414e-07 -0.09924129213059124 +1.8335 0.7057654406084816 0.7057639488753417 1.609727242127268e-07 -0.09924152173781911 +1.8336000000000001 0.7057658493079149 0.7057643532583027 1.5858220956191382e-07 -0.09924175127582552 +1.8337 0.7057662578583563 0.705764757544661 1.5614606283659294e-07 -0.0992419807446312 +1.8338 0.7057666662593605 0.7057651617349354 1.536648576404287e-07 -0.09924221014425685 +1.8339 0.705767074510488 0.7057655658296389 1.5113917775991248e-07 -0.09924243947472318 +1.834 0.7057674826113065 0.7057659698292783 1.4856961705334015e-07 -0.0992426687360509 +1.8341 0.7057678905613894 0.7057663737343531 1.4595677925652306e-07 -0.09924289792826066 +1.8342 0.7057682983603174 0.7057667775453571 1.4330127790299074e-07 -0.0992431270513732 +1.8343000000000003 0.7057687060076773 0.7057671812627765 1.4060373615051858e-07 -0.09924335610540913 +1.8344 0.7057691135030626 0.7057675848870911 1.3786478663194157e-07 -0.09924358509038908 +1.8345 0.7057695208460744 0.7057679884187742 1.3508507129902925e-07 -0.09924381400633381 +1.8346000000000002 0.7057699280363201 0.7057683918582918 1.3226524131146333e-07 -0.09924404285326392 +1.8347 0.7057703350734147 0.7057687952061023 1.2940595684254874e-07 -0.09924427163120005 +1.8348000000000002 0.70577074195698 0.7057691984626575 1.2650788693696624e-07 -0.09924450034016291 +1.8349000000000002 0.7057711486866449 0.7057696016284019 1.2357170936852513e-07 -0.09924472898017306 +1.835 0.7057715552620465 0.705770004703772 1.2059811045628255e-07 -0.09924495755125112 +1.8351000000000002 0.7057719616828284 0.7057704076891979 1.1758778494311284e-07 -0.09924518605341777 +1.8352 0.7057723679486424 0.7057708105851009 1.1454143578407128e-07 -0.09924541448669362 +1.8353000000000002 0.7057727740591473 0.7057712133918956 1.1145977402149398e-07 -0.09924564285109926 +1.8354000000000001 0.7057731800140106 0.7057716161099886 1.0834351860111724e-07 -0.09924587114665531 +1.8355 0.7057735858129062 0.7057720187397781 1.0519339621942181e-07 -0.09924609937338232 +1.8356000000000001 0.7057739914555172 0.7057724212816556 1.0201014112240503e-07 -0.09924632753130094 +1.8357 0.7057743969415338 0.7057728237360037 9.879449496333348e-08 -0.09924655562043173 +1.8358 0.7057748022706547 0.705773226103197 9.554720663274008e-08 -0.09924678364079531 +1.8359 0.7057752074425866 0.7057736283836025 9.226903206066561e-08 -0.09924701159241224 +1.836 0.705775612457044 0.7057740305775784 8.896073407441141e-08 -0.09924723947530306 +1.8361 0.7057760173137504 0.7057744326854749 8.562308217302528e-08 -0.09924746728948834 +1.8362 0.7057764220124367 0.7057748347076339 8.225685240240144e-08 -0.09924769503498865 +1.8363000000000003 0.7057768265528431 0.7057752366443888 7.886282712456227e-08 -0.09924792271182452 +1.8364 0.7057772309347177 0.7057756384960647 7.544179486673741e-08 -0.09924815032001653 +1.8365 0.7057776351578171 0.705776040262978 7.19945501513608e-08 -0.09924837785958521 +1.8366000000000002 0.7057780392219068 0.7057764419454362 6.852189326708724e-08 -0.09924860533055105 +1.8367 0.7057784431267606 0.7057768435437388 6.502463011613668e-08 -0.0992488327329346 +1.8368000000000002 0.7057788468721616 0.7057772450581763 6.15035720182705e-08 -0.09924906006675645 +1.8369000000000002 0.7057792504579008 0.70577764648903 5.7959535530380246e-08 -0.099249287332037 +1.837 0.7057796538837784 0.7057780478365729 5.439334224352499e-08 -0.09924951452879681 +1.8371000000000002 0.7057800571496035 0.705778449101069 5.080581859731592e-08 -0.09924974165705638 +1.8372 0.7057804602551943 0.7057788502827735 4.719779569603566e-08 -0.09924996871683622 +1.8373000000000002 0.7057808632003775 0.7057792513819321 4.3570109102206156e-08 -0.09925019570815678 +1.8374000000000001 0.7057812659849892 0.7057796523987819 3.992359866658579e-08 -0.09925042263103857 +1.8375 0.7057816686088744 0.7057800533335512 3.625910830265533e-08 -0.0992506494855021 +1.8376000000000001 0.7057820710718872 0.7057804541864585 3.257748581488029e-08 -0.0992508762715678 +1.8377000000000001 0.7057824733738907 0.7057808549577136 2.887958269748303e-08 -0.09925110298925616 +1.8378 0.7057828755147575 0.7057812556475171 2.5166253924541193e-08 -0.09925132963858763 +1.8379 0.7057832774943686 0.7057816562560602 2.1438357779984818e-08 -0.09925155621958263 +1.838 0.7057836793126158 0.7057820567835249 1.7696755628612837e-08 -0.0992517827322617 +1.8381 0.705784080969398 0.7057824572300844 1.3942311740018642e-08 -0.09925200917664521 +1.8382 0.7057844824646254 0.7057828575959014 1.0175893074351738e-08 -0.09925223555275359 +1.8383000000000003 0.7057848837982164 0.7057832578811307 6.3983690906307955e-09 -0.09925246186060731 +1.8384 0.7057852849700987 0.7057836580859168 2.6106115429136434e-09 -0.09925268810022678 +1.8385 0.70578568598021 0.7057840582103949 -1.1865057209306529e-09 -0.09925291427163235 +1.8386000000000002 0.7057860868284969 0.7057844582546913 -4.9921069587149924e-09 -0.09925314037484456 +1.8387 0.7057864875149157 0.7057848582189221 -8.805314738631609e-09 -0.09925336640988372 +1.8388000000000002 0.7057868880394318 0.7057852581031949 -1.262525013917895e-08 -0.09925359237677027 +1.8389000000000002 0.70578728840202 0.705785657907607 -1.645103295342537e-08 -0.09925381827552454 +1.839 0.7057876886026654 0.7057860576322466 -2.028178188980337e-08 -0.099254044106167 +1.8391000000000002 0.7057880886413614 0.7057864572771926 -2.4116614774638556e-08 -0.09925426986871802 +1.8392 0.7057884885181115 0.7057868568425143 -2.7954648760750156e-08 -0.09925449556319797 +1.8393000000000002 0.7057888882329284 0.7057872563282714 -3.179500052325791e-08 -0.09925472118962719 +1.8394000000000001 0.7057892877858344 0.705787655734514 -3.5636786468833115e-08 -0.09925494674802607 +1.8395 0.7057896871768613 0.7057880550612832 -3.9479122931939184e-08 -0.09925517223841498 +1.8396000000000001 0.7057900864060501 0.7057884543086097 -4.332112638560058e-08 -0.0992553976608142 +1.8397000000000001 0.7057904854734518 0.7057888534765158 -4.7161913642034415e-08 -0.09925562301524415 +1.8398 0.7057908843791263 0.705789252565014 -5.1000602051005234e-08 -0.09925584830172518 +1.8399 0.705791283123143 0.7057896515741069 -5.483630970961814e-08 -0.09925607352027754 +1.84 0.7057916817055812 0.7057900505037876 -5.86681556601857e-08 -0.09925629867092162 +1.8401 0.7057920801265289 0.7057904493540407 -6.249526009454581e-08 -0.09925652375367772 +1.8402 0.7057924783860845 0.7057908481248405 -6.631674455415126e-08 -0.09925674876856616 +1.8403000000000003 0.7057928764843548 0.705791246816152 -7.013173213346602e-08 -0.09925697371560728 +1.8404 0.7057932744214566 0.7057916454279312 -7.393934767837423e-08 -0.09925719859482136 +1.8405 0.7057936721975157 0.705792043960124 -7.77387179949976e-08 -0.09925742340622869 +1.8406000000000002 0.7057940698126673 0.7057924424126683 -8.152897203791282e-08 -0.09925764814984961 +1.8407 0.7057944672670561 0.7057928407854909 -8.530924111571636e-08 -0.09925787282570434 +1.8408000000000002 0.7057948645608358 0.7057932390785105 -8.907865909485446e-08 -0.09925809743381316 +1.8409 0.7057952616941696 0.7057936372916367 -9.283636259131006e-08 -0.0992583219741964 +1.841 0.7057956586672298 0.7057940354247687 -9.658149116489184e-08 -0.0992585464468743 +1.8411000000000002 0.7057960554801976 0.7057944334777977 -1.0031318752740104e-07 -0.0992587708518671 +1.8412 0.705796452133264 0.7057948314506048 -1.040305977317163e-07 -0.09925899518919508 +1.8413000000000002 0.7057968486266286 0.705795229343063 -1.0773287136955217e-07 -0.0992592194588785 +1.8414000000000001 0.7057972449605002 0.7057956271550353 -1.1141916175794186e-07 -0.09925944366093763 +1.8415 0.7057976411350961 0.7057960248863759 -1.1508862615174087e-07 -0.09925966779539261 +1.8416000000000001 0.7057980371506436 0.7057964225369304 -1.1874042590322154e-07 -0.0992598918622637 +1.8417000000000001 0.7057984330073781 0.7057968201065349 -1.2237372670059754e-07 -0.09926011586157119 +1.8418 0.7057988287055446 0.7057972175950169 -1.2598769871634274e-07 -0.09926033979333526 +1.8419 0.7057992242453961 0.7057976150021953 -1.2958151681188856e-07 -0.09926056365757617 +1.842 0.7057996196271947 0.7057980123278795 -1.3315436073538245e-07 -0.09926078745431403 +1.8421 0.7058000148512116 0.7057984095718707 -1.367054152934255e-07 -0.09926101118356913 +1.8422 0.7058004099177264 0.7057988067339611 -1.402338705523004e-07 -0.09926123484536163 +1.8423000000000003 0.7058008048270272 0.7057992038139348 -1.4373892199930072e-07 -0.09926145843971175 +1.8424 0.7058011995794108 0.7057996008115667 -1.4721977075263237e-07 -0.09926168196663966 +1.8425 0.7058015941751822 0.7057999977266236 -1.5067562373141663e-07 -0.09926190542616553 +1.8426000000000002 0.7058019886146552 0.7058003945588636 -1.5410569383436656e-07 -0.09926212881830951 +1.8427 0.7058023828981519 0.7058007913080364 -1.5750920011499414e-07 -0.09926235214309181 +1.8428000000000002 0.7058027770260022 0.7058011879738837 -1.6088536797589925e-07 -0.09926257540053257 +1.8429 0.7058031709985451 0.705801584556139 -1.6423342933183371e-07 -0.09926279859065196 +1.843 0.7058035648161267 0.7058019810545271 -1.6755262278317362e-07 -0.09926302171347007 +1.8431000000000002 0.7058039584791022 0.7058023774687652 -1.7084219379980004e-07 -0.09926324476900712 +1.8432 0.7058043519878339 0.7058027737985624 -1.7410139488242826e-07 -0.09926346775728319 +1.8433000000000002 0.7058047453426926 0.7058031700436197 -1.773294857274066e-07 -0.09926369067831847 +1.8434000000000001 0.7058051385440568 0.7058035662036304 -1.805257334210053e-07 -0.09926391353213308 +1.8435 0.7058055315923126 0.7058039622782799 -1.8368941257299043e-07 -0.09926413631874707 +1.8436000000000001 0.7058059244878538 0.7058043582672457 -1.8681980549009602e-07 -0.0992643590381806 +1.8437000000000001 0.7058063172310822 0.7058047541701984 -1.8991620237551743e-07 -0.09926458169045375 +1.8438 0.7058067098224066 0.7058051499868003 -1.9297790142605575e-07 -0.09926480427558666 +1.8439 0.7058071022622434 0.7058055457167067 -1.960042090333458e-07 -0.09926502679359943 +1.844 0.7058074945510162 0.7058059413595656 -1.9899443995732846e-07 -0.09926524924451212 +1.8441 0.7058078866891562 0.7058063369150172 -2.0194791741645624e-07 -0.09926547162834481 +1.8442 0.7058082786771012 0.7058067323826951 -2.0486397330279904e-07 -0.09926569394511754 +1.8443000000000003 0.7058086705152964 0.7058071277622258 -2.0774194831388315e-07 -0.09926591619485048 +1.8444 0.7058090622041941 0.7058075230532286 -2.1058119207412185e-07 -0.09926613837756366 +1.8445 0.7058094537442532 0.7058079182553161 -2.13381063325635e-07 -0.09926636049327714 +1.8446000000000002 0.7058098451359394 0.7058083133680939 -2.1614093005314916e-07 -0.09926658254201098 +1.8447 0.7058102363797247 0.705808708391161 -2.188601696123671e-07 -0.09926680452378517 +1.8448000000000002 0.7058106274760884 0.7058091033241098 -2.215381688999707e-07 -0.09926702643861979 +1.8449 0.7058110184255155 0.7058094981665268 -2.2417432447158214e-07 -0.09926724828653488 +1.845 0.705811409228498 0.7058098929179912 -2.267680426909502e-07 -0.09926747006755048 +1.8451000000000002 0.7058117998855336 0.705810287578077 -2.2931873982362516e-07 -0.09926769178168662 +1.8452 0.7058121903971264 0.7058106821463508 -2.3182584223818692e-07 -0.09926791342896328 +1.8453000000000002 0.7058125807637864 0.7058110766223742 -2.342887864686949e-07 -0.09926813500940052 +1.8454000000000002 0.7058129709860297 0.7058114710057022 -2.3670701938469096e-07 -0.0992683565230183 +1.8455 0.7058133610643779 0.7058118652958846 -2.3907999829875237e-07 -0.09926857796983665 +1.8456000000000001 0.7058137509993583 0.705812259492465 -2.4140719108445285e-07 -0.09926879934987554 +1.8457000000000001 0.7058141407915041 0.7058126535949817 -2.43688076287385e-07 -0.09926902066315496 +1.8458 0.7058145304413539 0.7058130476029674 -2.459221432778158e-07 -0.09926924190969494 +1.8459 0.7058149199494513 0.7058134415159492 -2.4810889233742306e-07 -0.0992694630895154 +1.846 0.7058153093163454 0.7058138353334498 -2.502478347772563e-07 -0.09926968420263638 +1.8461 0.7058156985425901 0.7058142290549857 -2.5233849302100375e-07 -0.09926990524907775 +1.8462 0.7058160876287444 0.7058146226800694 -2.543804007576478e-07 -0.09927012622885956 +1.8463000000000003 0.7058164765753725 0.7058150162082077 -2.563731030316707e-07 -0.09927034714200174 +1.8464 0.7058168653830428 0.7058154096389033 -2.5831615631244365e-07 -0.09927056798852421 +1.8465 0.7058172540523286 0.7058158029716537 -2.6020912862259604e-07 -0.09927078876844692 +1.8466000000000002 0.7058176425838076 0.7058161962059525 -2.620515996316908e-07 -0.09927100948178981 +1.8467 0.7058180309780621 0.7058165893412883 -2.638431607429603e-07 -0.09927123012857285 +1.8468000000000002 0.705818419235678 0.7058169823771461 -2.6558341521126794e-07 -0.09927145070881593 +1.8469 0.7058188073572458 0.7058173753130061 -2.6727197815698545e-07 -0.09927167122253892 +1.847 0.7058191953433601 0.7058177681483451 -2.6890847674293505e-07 -0.0992718916697618 +1.8471000000000002 0.7058195831946188 0.7058181608826356 -2.7049255019173657e-07 -0.09927211205050446 +1.8472 0.7058199709116241 0.7058185535153467 -2.720238498829519e-07 -0.09927233236478678 +1.8473000000000002 0.7058203584949814 0.7058189460459436 -2.7350203946410745e-07 -0.09927255261262867 +1.8474000000000002 0.7058207459452994 0.7058193384738886 -2.749267948472245e-07 -0.09927277279405002 +1.8475 0.7058211332631907 0.7058197307986398 -2.7629780436494444e-07 -0.09927299290907073 +1.8476000000000001 0.7058215204492705 0.7058201230196529 -2.776147687705288e-07 -0.09927321295771063 +1.8477000000000001 0.7058219075041574 0.7058205151363801 -2.7887740135928984e-07 -0.09927343293998965 +1.8478 0.7058222944284728 0.7058209071482708 -2.800854279928766e-07 -0.09927365285592767 +1.8479 0.7058226812228408 0.7058212990547714 -2.81238587168664e-07 -0.09927387270554448 +1.848 0.7058230678878881 0.7058216908553261 -2.8233663007873333e-07 -0.09927409248885996 +1.8481 0.7058234544242439 0.705822082549376 -2.833793206584445e-07 -0.09927431220589393 +1.8482 0.7058238408325402 0.7058224741363601 -2.8436643563153896e-07 -0.09927453185666626 +1.8483000000000003 0.7058242271134108 0.7058228656157153 -2.8529776458993683e-07 -0.09927475144119682 +1.8484 0.7058246132674916 0.7058232569868765 -2.8617310999720647e-07 -0.09927497095950545 +1.8485 0.7058249992954204 0.7058236482492761 -2.8699228725101444e-07 -0.09927519041161187 +1.8486000000000002 0.7058253851978371 0.705824039402345 -2.877551247212895e-07 -0.099275409797536 +1.8487 0.7058257709753832 0.7058244304455124 -2.8846146376063087e-07 -0.09927562911729765 +1.8488000000000002 0.7058261566287014 0.7058248213782058 -2.891111588118611e-07 -0.09927584837091658 +1.8489 0.7058265421584361 0.7058252121998514 -2.8970407733863723e-07 -0.09927606755841258 +1.849 0.705826927565233 0.7058256029098742 -2.9024009991565625e-07 -0.0992762866798055 +1.8491000000000002 0.7058273128497388 0.705825993507698 -2.9071912024600244e-07 -0.0992765057351151 +1.8492 0.7058276980126008 0.7058263839927454 -2.911410451333918e-07 -0.09927672472436115 +1.8493000000000002 0.7058280830544679 0.7058267743644386 -2.9150579456196923e-07 -0.09927694364756343 +1.8494000000000002 0.7058284679759889 0.7058271646221987 -2.9181330170671704e-07 -0.09927716250474171 +1.8495 0.7058288527778137 0.7058275547654467 -2.9206351287794363e-07 -0.09927738129591579 +1.8496000000000001 0.7058292374605925 0.7058279447936024 -2.922563876184281e-07 -0.0992776000211054 +1.8497000000000001 0.7058296220249756 0.7058283347060861 -2.923918986375007e-07 -0.09927781868033032 +1.8498 0.7058300064716136 0.7058287245023174 -2.924700318596152e-07 -0.09927803727361031 +1.8499 0.7058303908011567 0.7058291141817163 -2.924907863965931e-07 -0.09927825580096505 +1.85 0.7058307750142555 0.7058295037437027 -2.924541745788489e-07 -0.09927847426241433 +1.8501 0.7058311591115598 0.705829893187697 -2.923602218721233e-07 -0.09927869265797785 +1.8502 0.7058315430937193 0.70583028251312 -2.922089669607497e-07 -0.0992789109876754 +1.8503000000000003 0.7058319269613829 0.7058306717193924 -2.92000461688674e-07 -0.09927912925152661 +1.8504 0.7058323107151989 0.7058310608059366 -2.917347710212903e-07 -0.09927934744955125 +1.8505 0.7058326943558145 0.7058314497721754 -2.914119730974829e-07 -0.099279565581769 +1.8506000000000002 0.7058330778838764 0.7058318386175325 -2.9103215910819547e-07 -0.09927978364819962 +1.8507 0.7058334613000297 0.7058322273414329 -2.9059543337969784e-07 -0.09928000164886275 +1.8508000000000002 0.7058338446049182 0.7058326159433027 -2.901019132660332e-07 -0.09928021958377808 +1.8509 0.7058342277991847 0.7058330044225696 -2.8955172916289573e-07 -0.09928043745296537 +1.851 0.7058346108834698 0.7058333927786625 -2.889450244382419e-07 -0.0992806552564442 +1.8511000000000002 0.7058349938584129 0.7058337810110122 -2.8828195542188184e-07 -0.09928087299423423 +1.8512 0.7058353767246512 0.7058341691190517 -2.875626913603768e-07 -0.09928109066635521 +1.8513000000000002 0.7058357594828204 0.7058345571022155 -2.867874143719362e-07 -0.09928130827282677 +1.8514000000000002 0.7058361421335535 0.7058349449599404 -2.859563193770287e-07 -0.09928152581366857 +1.8515 0.7058365246774818 0.7058353326916651 -2.850696141018516e-07 -0.09928174328890027 +1.8516000000000001 0.705836907115234 0.7058357202968311 -2.841275189811865e-07 -0.09928196069854152 +1.8517000000000001 0.7058372894474356 0.705836107774882 -2.8313026714105183e-07 -0.0992821780426119 +1.8518000000000001 0.7058376716747108 0.7058364951252647 -2.8207810429461966e-07 -0.09928239532113109 +1.8519 0.7058380537976797 0.7058368823474284 -2.80971288745685e-07 -0.09928261253411876 +1.852 0.7058384358169603 0.7058372694408248 -2.798100912221324e-07 -0.09928282968159444 +1.8521 0.705838817733167 0.7058376564049096 -2.7859479494185546e-07 -0.0992830467635778 +1.8522 0.7058391995469113 0.7058380432391409 -2.773256954462233e-07 -0.09928326378008843 +1.8523000000000003 0.7058395812588014 0.7058384299429807 -2.760031005619168e-07 -0.09928348073114594 +1.8524 0.7058399628694421 0.705838816515894 -2.7462733032113107e-07 -0.09928369761676993 +1.8525 0.7058403443794339 0.7058392029573493 -2.731987169234118e-07 -0.09928391443697998 +1.8526000000000002 0.7058407257893746 0.7058395892668192 -2.7171760456912164e-07 -0.0992841311917957 +1.8527 0.7058411070998576 0.7058399754437801 -2.7018434947331804e-07 -0.09928434788123663 +1.8528000000000002 0.7058414883114725 0.705840361487712 -2.6859931970962814e-07 -0.09928456450532241 +1.8529 0.7058418694248043 0.7058407473980992 -2.6696289515126814e-07 -0.09928478106407251 +1.853 0.7058422504404347 0.7058411331744303 -2.652754673704294e-07 -0.09928499755750661 +1.8531000000000002 0.7058426313589401 0.7058415188161979 -2.635374395758283e-07 -0.09928521398564417 +1.8532 0.7058430121808932 0.7058419043228996 -2.6174922646352017e-07 -0.09928543034850483 +1.8533000000000002 0.7058433929068616 0.7058422896940368 -2.5991125415444905e-07 -0.09928564664610805 +1.8534000000000002 0.7058437735374085 0.7058426749291167 -2.5802396009730333e-07 -0.09928586287847344 +1.8535 0.7058441540730918 0.70584306002765 -2.560877929297378e-07 -0.09928607904562048 +1.8536000000000001 0.7058445345144647 0.7058434449891534 -2.5410321241245426e-07 -0.09928629514756875 +1.8537000000000001 0.7058449148620756 0.7058438298131482 -2.5207068930777066e-07 -0.0992865111843377 +1.8538000000000001 0.7058452951164672 0.705844214499161 -2.499907052443129e-07 -0.09928672715594691 +1.8539 0.7058456752781774 0.7058445990467233 -2.4786375261293125e-07 -0.09928694306241587 +1.854 0.7058460553477386 0.7058449834553726 -2.4569033448690325e-07 -0.0992871589037641 +1.8541 0.7058464353256773 0.7058453677246515 -2.4347096446233896e-07 -0.09928737468001109 +1.8542 0.7058468152125147 0.7058457518541084 -2.412061665436893e-07 -0.09928759039117634 +1.8543000000000003 0.7058471950087659 0.7058461358432975 -2.3889647503619327e-07 -0.09928780603727934 +1.8544 0.7058475747149404 0.7058465196917785 -2.365424343932221e-07 -0.09928802161833955 +1.8545 0.7058479543315417 0.7058469033991177 -2.3414459911566543e-07 -0.09928823713437648 +1.8546 0.705848333859067 0.7058472869648864 -2.3170353362009233e-07 -0.09928845258540953 +1.8547 0.7058487132980078 0.7058476703886634 -2.2921981207915665e-07 -0.09928866797145826 +1.8548000000000002 0.7058490926488487 0.7058480536700327 -2.2669401832098313e-07 -0.09928888329254205 +1.8549 0.7058494719120685 0.7058484368085852 -2.2412674564528667e-07 -0.09928909854868043 +1.855 0.7058498510881392 0.705848819803918 -2.2151859674704455e-07 -0.0992893137398928 +1.8551000000000002 0.7058502301775262 0.7058492026556351 -2.1887018351873788e-07 -0.09928952886619863 +1.8552 0.7058506091806884 0.7058495853633466 -2.1618212693585992e-07 -0.09928974392761733 +1.8553000000000002 0.7058509880980777 0.7058499679266699 -2.1345505691119926e-07 -0.09928995892416834 +1.8554000000000002 0.7058513669301392 0.7058503503452287 -2.1068961215259252e-07 -0.09929017385587105 +1.8555 0.7058517456773111 0.7058507326186545 -2.078864399755742e-07 -0.09929038872274497 +1.8556000000000001 0.7058521243400244 0.705851114746585 -2.0504619619929332e-07 -0.09929060352480942 +1.8557000000000001 0.7058525029187033 0.7058514967286655 -2.0216954494875483e-07 -0.09929081826208386 +1.8558000000000001 0.7058528814137643 0.7058518785645485 -1.9925715855767523e-07 -0.0992910329345877 +1.8559 0.7058532598256169 0.7058522602538934 -1.963097173637851e-07 -0.0992912475423403 +1.856 0.705853638154663 0.7058526417963673 -1.9332790954576518e-07 -0.09929146208536103 +1.8561 0.705854016401297 0.7058530231916447 -1.9031243099834616e-07 -0.09929167656366931 +1.8562 0.705854394565906 0.705853404439408 -1.8726398515189757e-07 -0.09929189097728458 +1.8563000000000003 0.7058547726488695 0.7058537855393465 -1.8418328280589424e-07 -0.09929210532622612 +1.8564 0.7058551506505588 0.7058541664911577 -1.8107104195891344e-07 -0.09929231961051335 +1.8565 0.7058555285713379 0.7058545472945468 -1.779279876733264e-07 -0.09929253383016559 +1.8566 0.7058559064115626 0.705854927949227 -1.7475485184978434e-07 -0.09929274798520227 +1.8567 0.705856284171581 0.7058553084549188 -1.7155237311272664e-07 -0.09929296207564267 +1.8568000000000002 0.7058566618517328 0.7058556888113513 -1.6832129660741824e-07 -0.09929317610150616 +1.8569 0.70585703945235 0.7058560690182615 -1.650623738299467e-07 -0.09929339006281207 +1.857 0.7058574169737563 0.7058564490753945 -1.6177636246415827e-07 -0.0992936039595797 +1.8571000000000002 0.7058577944162673 0.7058568289825037 -1.5846402618389932e-07 -0.09929381779182844 +1.8572 0.7058581717801902 0.7058572087393504 -1.551261345125038e-07 -0.0992940315595776 +1.8573000000000002 0.7058585490658242 0.7058575883457048 -1.5176346259901385e-07 -0.09929424526284653 +1.8574000000000002 0.7058589262734598 0.7058579678013449 -1.4837679107246315e-07 -0.09929445890165448 +1.8575 0.7058593034033787 0.7058583471060575 -1.4496690584585303e-07 -0.09929467247602078 +1.8576000000000001 0.7058596804558546 0.7058587262596375 -1.4153459794788437e-07 -0.0992948859859647 +1.8577000000000001 0.7058600574311527 0.7058591052618887 -1.3808066330611712e-07 -0.09929509943150555 +1.8578000000000001 0.7058604343295292 0.7058594841126234 -1.3460590260992722e-07 -0.09929531281266264 +1.8579 0.7058608111512321 0.7058598628116624 -1.3111112108325773e-07 -0.09929552612945526 +1.858 0.7058611878965007 0.7058602413588353 -1.275971283215549e-07 -0.09929573938190266 +1.8581 0.7058615645655648 0.7058606197539805 -1.240647380905402e-07 -0.0992959525700241 +1.8582 0.7058619411586462 0.7058609979969448 -1.2051476815620743e-07 -0.09929616569383887 +1.8583000000000003 0.7058623176759575 0.7058613760875843 -1.1694804007839066e-07 -0.09929637875336621 +1.8584 0.7058626941177026 0.7058617540257635 -1.1336537902688348e-07 -0.09929659174862537 +1.8585 0.7058630704840767 0.705862131811356 -1.0976761359408893e-07 -0.09929680467963563 +1.8586 0.7058634467752657 0.7058625094442448 -1.0615557559379152e-07 -0.09929701754641626 +1.8587 0.7058638229914465 0.7058628869243205 -1.0253009988074602e-07 -0.0992972303489864 +1.8588000000000002 0.7058641991327872 0.705863264251484 -9.889202414858217e-08 -0.09929744308736532 +1.8589 0.705864575199447 0.705863641425645 -9.524218874071982e-08 -0.0992976557615723 +1.859 0.7058649511915756 0.7058640184467214 -9.158143645261047e-08 -0.09929786837162653 +1.8591000000000002 0.705865327109314 0.7058643953146411 -8.791061234265235e-08 -0.0992980809175472 +1.8592 0.7058657029527942 0.7058647720293403 -8.423056353876884e-08 -0.09929829339935349 +1.8593000000000002 0.7058660787221382 0.7058651485907652 -8.054213903371105e-08 -0.09929850581706468 +1.8594000000000002 0.7058664544174607 0.7058655249988703 -7.684618949597294e-08 -0.0992987181706999 +1.8595 0.7058668300388651 0.7058659012536197 -7.314356706899713e-08 -0.09929893046027843 +1.8596000000000001 0.7058672055864471 0.7058662773549864 -6.943512518209002e-08 -0.0992991426858194 +1.8597000000000001 0.7058675810602926 0.7058666533029525 -6.572171834832649e-08 -0.09929935484734193 +1.8598000000000001 0.7058679564604784 0.7058670290975098 -6.20042019676588e-08 -0.0992995669448653 +1.8599 0.7058683317870722 0.7058674047386584 -5.8283432133928587e-08 -0.09929977897840858 +1.86 0.7058687070401328 0.7058677802264084 -5.45602654310369e-08 -0.09929999094799105 +1.8601 0.7058690822197091 0.7058681555607784 -5.08355587434256e-08 -0.09930020285363177 +1.8602 0.7058694573258415 0.7058685307417969 -4.711016905463265e-08 -0.09930041469534995 +1.8603000000000003 0.7058698323585604 0.7058689057695009 -4.3384953249370976e-08 -0.09930062647316469 +1.8604 0.705870207317888 0.7058692806439372 -3.966076792032364e-08 -0.09930083818709518 +1.8605 0.7058705822038365 0.7058696553651612 -3.593846916859645e-08 -0.09930104983716051 +1.8606 0.705870957016409 0.7058700299332379 -3.221891240498369e-08 -0.09930126142337986 +1.8607 0.7058713317556002 0.7058704043482409 -2.8502952158226957e-08 -0.0993014729457723 +1.8608000000000002 0.7058717064213946 0.7058707786102536 -2.4791441876389347e-08 -0.09930168440435698 +1.8609 0.7058720810137683 0.7058711527193682 -2.108523373131957e-08 -0.099301895799153 +1.861 0.7058724555326878 0.7058715266756861 -1.738517842056822e-08 -0.09930210713017948 +1.8611000000000002 0.7058728299781107 0.7058719004793175 -1.369212497591768e-08 -0.0993023183974555 +1.8612 0.7058732043499856 0.705872274130382 -1.0006920566490995e-08 -0.09930252960100017 +1.8613000000000002 0.7058735786482518 0.705872647629008 -6.330410306197576e-09 -0.09930274074083256 +1.8614000000000002 0.7058739528728397 0.7058730209753333 -2.6634370568420773e-09 -0.09930295181697174 +1.8615 0.7058743270236709 0.7058733941695046 9.931587574910083e-10 -0.0993031628294369 +1.8616000000000001 0.7058747011006574 0.7058737672116773 4.638539359905214e-09 -0.09930337377824695 +1.8617000000000001 0.7058750751037026 0.7058741401020155 8.271869788092912e-09 -0.09930358466342105 +1.8618000000000001 0.7058754490327013 0.705874512840693 1.189231810683894e-08 -0.09930379548497827 +1.8619 0.705875822887539 0.705874885427892 1.5499055585829757e-08 -0.09930400624293764 +1.862 0.7058761966680925 0.7058752578638039 1.909125690088137e-08 -0.09930421693731827 +1.8621 0.7058765703742294 0.705875630148628 2.266810031001376e-08 -0.09930442756813906 +1.8622 0.7058769440058088 0.7058760022825732 2.6228767841668388e-08 -0.09930463813541918 +1.8623000000000003 0.7058773175626814 0.7058763742658571 2.977244549333402e-08 -0.09930484863917761 +1.8624 0.7058776910446887 0.7058767460987057 3.329832341802952e-08 -0.09930505907943342 +1.8625 0.705878064451664 0.7058771177813535 3.680559608823519e-08 -0.09930526945620562 +1.8626 0.7058784377834315 0.7058774893140438 4.029346250405963e-08 -0.09930547976951315 +1.8627 0.7058788110398072 0.7058778606970281 4.376112635630369e-08 -0.09930569001937511 +1.8628000000000002 0.7058791842205987 0.705878231930567 4.720779622942317e-08 -0.09930590020581048 +1.8629 0.705879557325605 0.7058786030149291 5.063268576632751e-08 -0.09930611032883828 +1.863 0.7058799303546166 0.7058789739503912 5.403501384532161e-08 -0.09930632038847748 +1.8631000000000002 0.7058803033074158 0.7058793447372389 5.741400477266012e-08 -0.09930653038474706 +1.8632 0.7058806761837766 0.7058797153757653 6.076888845081563e-08 -0.099306740317666 +1.8633000000000002 0.7058810489834648 0.7058800858662726 6.40989005450121e-08 -0.09930695018725329 +1.8634000000000002 0.7058814217062386 0.7058804562090704 6.740328268965701e-08 -0.09930715999352793 +1.8635 0.7058817943518472 0.7058808264044765 7.06812826167108e-08 -0.09930736973650885 +1.8636000000000001 0.7058821669200321 0.7058811964528169 7.393215435864964e-08 -0.09930757941621504 +1.8637000000000001 0.7058825394105274 0.7058815663544253 7.715515840112097e-08 -0.0993077890326654 +1.8638000000000001 0.7058829118230586 0.7058819361096434 8.034956185641595e-08 -0.09930799858587894 +1.8639000000000001 0.7058832841573441 0.7058823057188206 8.351463864561537e-08 -0.09930820807587458 +1.864 0.7058836564130939 0.7058826751823137 8.664966963389809e-08 -0.0993084175026712 +1.8641 0.7058840285900112 0.705883044500488 8.975394282309535e-08 -0.09930862686628787 +1.8642 0.7058844006877907 0.705883413673715 9.282675348526448e-08 -0.09930883616674337 +1.8643000000000003 0.7058847727061204 0.705883782702375 9.586740434830432e-08 -0.09930904540405676 +1.8644 0.7058851446446803 0.7058841515868544 9.887520573820252e-08 -0.09930925457824683 +1.8645 0.7058855165031436 0.7058845203275481 1.0184947573863012e-07 -0.09930946368933255 +1.8646 0.705885888281176 0.7058848889248575 1.0478954035053611e-07 -0.09930967273733285 +1.8647 0.7058862599784361 0.7058852573791912 1.0769473364827253e-07 -0.09930988172226657 +1.8648000000000002 0.7058866315945753 0.7058856256909648 1.1056439790102512e-07 -0.0993100906441526 +1.8649 0.7058870031292387 0.7058859938606012 1.1339788375322457e-07 -0.0993102995030099 +1.865 0.7058873745820634 0.7058863618885298 1.1619455038414106e-07 -0.09931050829885729 +1.8651000000000002 0.7058877459526809 0.7058867297751868 1.1895376560155935e-07 -0.09931071703171372 +1.8652 0.7058881172407152 0.7058870975210152 1.216749060152511e-07 -0.09931092570159798 +1.8653000000000002 0.7058884884457837 0.7058874651264644 1.243573571896306e-07 -0.09931113430852893 +1.8654000000000002 0.7058888595674983 0.7058878325919902 1.2700051377212418e-07 -0.09931134285252549 +1.8655 0.7058892306054634 0.7058881999180554 1.296037796215399e-07 -0.09931155133360652 +1.8656000000000001 0.7058896015592773 0.7058885671051282 1.321665679294981e-07 -0.09931175975179081 +1.8657000000000001 0.7058899724285327 0.7058889341536831 1.3468830139390375e-07 -0.09931196810709722 +1.8658000000000001 0.7058903432128156 0.7058893010642013 1.37168412316091e-07 -0.0993121763995446 +1.8659000000000001 0.7058907139117064 0.7058896678371697 1.3960634273960104e-07 -0.09931238462915175 +1.866 0.7058910845247797 0.7058900344730807 1.4200154456467384e-07 -0.09931259279593757 +1.8661 0.7058914550516038 0.7058904009724329 1.4435347970090384e-07 -0.09931280089992087 +1.8662 0.7058918254917419 0.70589076733573 1.4666162015050666e-07 -0.09931300894112038 +1.8663000000000003 0.7058921958447515 0.7058911335634817 1.489254481505664e-07 -0.09931321691955505 +1.8664 0.7058925661101844 0.7058914996562029 1.511444562736497e-07 -0.09931342483524357 +1.8665 0.7058929362875872 0.705891865614414 1.5331814757352236e-07 -0.09931363268820476 +1.8666 0.7058933063765014 0.7058922314386402 1.554460356475995e-07 -0.0993138404784574 +1.8667 0.7058936763764634 0.7058925971294122 1.575276447791929e-07 -0.09931404820602031 +1.8668000000000002 0.7058940462870046 0.7058929626872654 1.5956251003812483e-07 -0.09931425587091226 +1.8669 0.7058944161076515 0.70589332811274 1.6155017739521993e-07 -0.09931446347315198 +1.867 0.705894785837926 0.7058936934063815 1.634902037778163e-07 -0.09931467101275836 +1.8671000000000002 0.7058951554773452 0.7058940585687392 1.6538215722936012e-07 -0.09931487848975008 +1.8672 0.7058955250254215 0.7058944236003674 1.6722561697879446e-07 -0.09931508590414591 +1.8673000000000002 0.7058958944816636 0.7058947885018243 1.690201735064789e-07 -0.09931529325596462 +1.8674000000000002 0.7058962638455752 0.705895153273673 1.7076542866562017e-07 -0.09931550054522492 +1.8675 0.7058966331166563 0.7058955179164802 1.7246099580370267e-07 -0.09931570777194564 +1.8676000000000001 0.7058970022944024 0.7058958824308168 1.7410649975208026e-07 -0.09931591493614539 +1.8677000000000001 0.705897371378306 0.7058962468172576 1.75701577002918e-07 -0.09931612203784301 +1.8678000000000001 0.7058977403678548 0.7058966110763808 1.772458757716422e-07 -0.09931632907705716 +1.8679000000000001 0.7058981092625338 0.7058969752087688 1.787390560108182e-07 -0.09931653605380662 +1.868 0.7058984780618238 0.705897339215007 1.8018078954892824e-07 -0.09931674296811005 +1.8681 0.7058988467652023 0.7058977030956848 1.8157076016322993e-07 -0.0993169498199862 +1.8682 0.705899215372144 0.7058980668513937 1.8290866360404223e-07 -0.09931715660945377 +1.8683 0.70589958388212 0.7058984304827296 1.8419420767107342e-07 -0.09931736333653146 +1.8684 0.7058999522945988 0.7058987939902903 1.8542711234526e-07 -0.09931757000123795 +1.8685 0.7059003206090455 0.7058991573746773 1.8660710975407224e-07 -0.09931777660359194 +1.8686 0.705900688824923 0.7058995206364942 1.877339442651893e-07 -0.0993179831436121 +1.8687 0.7059010569416914 0.7058998837763474 1.8880737259058256e-07 -0.09931818962131712 +1.8688000000000002 0.705901424958808 0.7059002467948456 1.8982716376222952e-07 -0.09931839603672565 +1.8689 0.7059017928757285 0.7059006096926006 1.9079309923619725e-07 -0.0993186023898564 +1.869 0.7059021606919058 0.705900972470225 1.9170497290305066e-07 -0.09931880868072797 +1.8691000000000002 0.7059025284067909 0.7059013351283345 1.9256259116071095e-07 -0.09931901490935903 +1.8692 0.705902896019833 0.7059016976675465 1.933657729248639e-07 -0.09931922107576827 +1.8693000000000002 0.7059032635304794 0.70590206008848 1.9411434970528774e-07 -0.09931942717997434 +1.8694000000000002 0.7059036309381755 0.7059024223917558 1.9480816561279202e-07 -0.09931963322199583 +1.8695 0.7059039982423657 0.705902784577996 1.954470773800343e-07 -0.09931983920185145 +1.8696000000000002 0.7059043654424925 0.7059031466478243 1.9603095443784802e-07 -0.09932004511955969 +1.8697000000000001 0.705904732537997 0.7059035086018653 1.9655967889789516e-07 -0.09932025097513925 +1.8698000000000001 0.7059050995283203 0.7059038704407454 1.9703314558736085e-07 -0.09932045676860876 +1.8699000000000001 0.7059054664129012 0.7059042321650911 1.9745126208017827e-07 -0.0993206624999868 +1.87 0.7059058331911785 0.7059045937755302 1.9781394870743707e-07 -0.099320868169292 +1.8701 0.7059061998625898 0.705904955272691 1.9812113855738334e-07 -0.09932107377654295 +1.8702 0.7059065664265725 0.7059053166572029 1.983727775274613e-07 -0.09932127932175826 +1.8703 0.7059069328825631 0.705905677929695 1.9856882428961886e-07 -0.09932148480495648 +1.8704 0.7059072992299985 0.705906039090797 1.9870925033194098e-07 -0.09932169022615622 +1.8705 0.7059076654683147 0.7059064001411388 1.9879403988579125e-07 -0.0993218955853761 +1.8706 0.7059080315969484 0.7059067610813501 1.9882319006112037e-07 -0.09932210088263464 +1.8707 0.7059083976153355 0.7059071219120603 1.9879671071462712e-07 -0.0993223061179504 +1.8708000000000002 0.7059087635229131 0.7059074826338991 1.987146245018001e-07 -0.09932251129134197 +1.8709 0.7059091293191182 0.7059078432474954 1.9857696687691773e-07 -0.09932271640282786 +1.871 0.7059094950033884 0.7059082037534778 1.9838378605488427e-07 -0.0993229214524267 +1.8711000000000002 0.7059098605751619 0.7059085641524738 1.9813514298347434e-07 -0.09932312644015699 +1.8712 0.7059102260338779 0.7059089244451106 1.9783111139884402e-07 -0.0993233313660373 +1.8713000000000002 0.7059105913789765 0.7059092846320136 1.9747177770063074e-07 -0.0993235362300861 +1.8714000000000002 0.7059109566098984 0.7059096447138083 1.9705724100399502e-07 -0.09932374103232199 +1.8715 0.7059113217260864 0.7059100046911181 1.965876130979871e-07 -0.09932394577276343 +1.8716000000000002 0.7059116867269837 0.705910364564565 1.9606301838309692e-07 -0.09932415045142896 +1.8717000000000001 0.7059120516120356 0.7059107243347704 1.954835938920707e-07 -0.09932435506833714 +1.8718000000000001 0.7059124163806887 0.705911084002353 1.9484948923093048e-07 -0.09932455962350639 +1.8719000000000001 0.7059127810323915 0.7059114435679306 1.9416086650611564e-07 -0.09932476411695527 +1.872 0.7059131455665945 0.7059118030321181 1.934179003314218e-07 -0.09932496854870226 +1.8721 0.7059135099827498 0.7059121623955293 1.9262077777248976e-07 -0.09932517291876584 +1.8722 0.7059138742803122 0.7059125216587754 1.9176969830170254e-07 -0.0993253772271645 +1.8723 0.7059142384587384 0.7059128808224655 1.908648737079799e-07 -0.09932558147391672 +1.8724 0.7059146025174876 0.7059132398872059 1.899065281037171e-07 -0.09932578565904099 +1.8725 0.7059149664560217 0.7059135988536007 1.8889489783804891e-07 -0.09932598978255577 +1.8726 0.7059153302738052 0.7059139577222513 1.8783023144827715e-07 -0.09932619384447955 +1.8727 0.7059156939703048 0.7059143164937562 1.867127896078291e-07 -0.09932639784483072 +1.8728000000000002 0.705916057544991 0.7059146751687109 1.8554284501176577e-07 -0.09932660178362779 +1.8729 0.7059164209973373 0.7059150337477074 1.8432068239759847e-07 -0.09932680566088917 +1.873 0.7059167843268198 0.7059153922313355 1.8304659838569437e-07 -0.09932700947663334 +1.8731000000000002 0.7059171475329185 0.7059157506201807 1.817209014688681e-07 -0.0993272132308787 +1.8732 0.7059175106151162 0.7059161089148256 1.803439119117678e-07 -0.0993274169236437 +1.8733000000000002 0.7059178735729 0.7059164671158491 1.789159616918945e-07 -0.09932762055494676 +1.8734000000000002 0.7059182364057603 0.7059168252238261 1.7743739440939654e-07 -0.09932782412480633 +1.8735 0.7059185991131911 0.7059171832393281 1.759085651725778e-07 -0.09932802763324076 +1.8736000000000002 0.705918961694691 0.7059175411629223 1.743298405978977e-07 -0.0993282310802685 +1.8737000000000001 0.7059193241497621 0.7059178989951718 1.7270159862955992e-07 -0.09932843446590797 +1.8738000000000001 0.7059196864779106 0.7059182567366359 1.7102422848400134e-07 -0.0993286377901775 +1.8739000000000001 0.7059200486786475 0.7059186143878693 1.6929813059091137e-07 -0.09932884105309558 +1.874 0.705920410751488 0.7059189719494221 1.6752371644404573e-07 -0.09932904425468052 +1.8741 0.7059207726959518 0.7059193294218398 1.6570140853530702e-07 -0.09932924739495065 +1.8742 0.7059211345115631 0.7059196868056643 1.6383164024025287e-07 -0.09932945047392451 +1.8743 0.7059214961978513 0.7059200441014312 1.6191485574176823e-07 -0.09932965349162037 +1.8744 0.70592185775435 0.7059204013096717 1.599515098704707e-07 -0.09932985644805657 +1.8745 0.7059222191805989 0.7059207584309126 1.5794206806654665e-07 -0.09933005934325154 +1.8746 0.7059225804761415 0.7059211154656748 1.558870061958706e-07 -0.09933026217722359 +1.8747 0.7059229416405275 0.7059214724144743 1.5378681051878007e-07 -0.09933046494999107 +1.8748000000000002 0.7059233026733114 0.705921829277822 1.5164197748884778e-07 -0.09933066766157234 +1.8749 0.7059236635740535 0.7059221860562226 1.4945301370083985e-07 -0.09933087031198574 +1.875 0.7059240243423193 0.7059225427501761 1.4722043575540744e-07 -0.09933107290124961 +1.8751000000000002 0.7059243849776802 0.705922899360176 1.4494477010643103e-07 -0.09933127542938223 +1.8752 0.7059247454797131 0.7059232558867108 1.4262655298816207e-07 -0.09933147789640193 +1.8753000000000002 0.7059251058480012 0.7059236123302628 1.4026633023828117e-07 -0.09933168030232709 +1.8754000000000002 0.7059254660821332 0.7059239686913079 1.3786465722157026e-07 -0.09933188264717596 +1.8755 0.7059258261817043 0.7059243249703167 1.354220986425625e-07 -0.0993320849309669 +1.8756000000000002 0.7059261861463155 0.7059246811677531 1.329392284657449e-07 -0.09933228715371818 +1.8757000000000001 0.7059265459755741 0.7059250372840744 1.3041662973514723e-07 -0.09933248931544807 +1.8758000000000001 0.7059269056690938 0.7059253933197327 1.27854894466789e-07 -0.09933269141617485 +1.8759000000000001 0.7059272652264947 0.7059257492751723 1.2525462349949334e-07 -0.09933289345591682 +1.876 0.7059276246474038 0.7059261051508317 1.2261642637692582e-07 -0.09933309543469228 +1.8761 0.7059279839314544 0.7059264609471427 1.199409211567748e-07 -0.0993332973525195 +1.8762 0.7059283430782864 0.7059268166645305 1.1722873431360692e-07 -0.09933349920941675 +1.8763 0.7059287020875469 0.7059271723034126 1.1448050054804759e-07 -0.09933370100540227 +1.8764 0.7059290609588895 0.7059275278642008 1.1169686268963641e-07 -0.09933390274049436 +1.8765 0.7059294196919752 0.7059278833472988 1.0887847149906871e-07 -0.0993341044147112 +1.8766 0.7059297782864716 0.7059282387531041 1.0602598557105103e-07 -0.09933430602807113 +1.8767 0.7059301367420538 0.7059285940820061 1.031400710949093e-07 -0.09933450758059227 +1.8768000000000002 0.705930495058404 0.7059289493343881 1.0022140181295547e-07 -0.09933470907229296 +1.8769 0.7059308532352114 0.7059293045106254 9.727065872211504e-08 -0.09933491050319138 +1.877 0.7059312112721734 0.7059296596110858 9.428853006351878e-08 -0.09933511187330576 +1.8771000000000002 0.705931569168994 0.7059300146361298 9.12757110657636e-08 -0.09933531318265436 +1.8772 0.7059319269253854 0.7059303695861104 8.823290380613469e-08 -0.09933551443125535 +1.8773000000000002 0.705932284541067 0.7059307244613728 8.516081704407208e-08 -0.09933571561912696 +1.8774000000000002 0.7059326420157659 0.7059310792622548 8.206016609280109e-08 -0.09933591674628739 +1.8775 0.7059329993492167 0.7059314339890862 7.893167258687939e-08 -0.0993361178127548 +1.8776000000000002 0.7059333565411627 0.7059317886421888 7.577606438505247e-08 -0.09933631881854742 +1.8777000000000001 0.7059337135913539 0.7059321432218771 7.25940753221882e-08 -0.0993365197636834 +1.8778000000000001 0.7059340704995494 0.7059324977284571 6.938644512947956e-08 -0.09933672064818098 +1.8779000000000001 0.705934427265515 0.7059328521622272 6.615391918811386e-08 -0.0993369214720583 +1.878 0.7059347838890256 0.7059332065234776 6.289724839049493e-08 -0.09933712223533354 +1.8781 0.7059351403698642 0.70593356081249 5.961718895983181e-08 -0.0993373229380249 +1.8782 0.7059354967078213 0.7059339150295381 5.631450227840118e-08 -0.09933752358015047 +1.8783 0.705935852902696 0.7059342691748877 5.298995469325829e-08 -0.09933772416172844 +1.8784 0.7059362089542955 0.7059346232487962 4.964431736705077e-08 -0.09933792468277697 +1.8785 0.7059365648624356 0.7059349772515124 4.627836606811708e-08 -0.0993381251433142 +1.8786 0.7059369206269401 0.7059353311832767 4.2892881019565565e-08 -0.09933832554335821 +1.8787 0.7059372762476418 0.7059356850443215 3.9488646703250696e-08 -0.09933852588292724 +1.8788000000000002 0.7059376317243813 0.7059360388348701 3.606645168630074e-08 -0.09933872616203931 +1.8789 0.7059379870570077 0.705936392555138 3.262708841815509e-08 -0.09933892638071261 +1.879 0.7059383422453795 0.7059367462053316 2.9171353058826677e-08 -0.09933912653896526 +1.8791000000000002 0.7059386972893626 0.7059370997856489 2.570004531757264e-08 -0.09933932663681529 +1.8792 0.7059390521888325 0.7059374532962792 2.221396823258448e-08 -0.09933952667428088 +1.8793000000000002 0.7059394069436726 0.7059378067374036 1.871392800792404e-08 -0.09933972665138016 +1.8794000000000002 0.7059397615537757 0.7059381601091936 1.520073381403031e-08 -0.09933992656813118 +1.8795 0.7059401160190426 0.705938513411813 1.1675197613379706e-08 -0.09934012642455203 +1.8796000000000002 0.705940470339383 0.7059388666454156 8.138133954053994e-09 -0.09934032622066076 +1.8797000000000001 0.7059408245147158 0.7059392198101477 4.590359807543631e-09 -0.0993405259564755 +1.8798000000000001 0.7059411785449682 0.7059395729061464 1.0326943536420607e-09 -0.09934072563201433 +1.8799000000000001 0.7059415324300765 0.7059399259335395 -2.5340411843530197e-09 -0.0993409252472953 +1.88 0.7059418861699854 0.7059402788924463 -6.10902375040856e-09 -0.09934112480233646 +1.8801 0.705942239764649 0.7059406317829774 -9.691428635300037e-09 -0.09934132429715586 +1.8802 0.7059425932140301 0.7059409846052345 -1.3280429660058463e-08 -0.09934152373177164 +1.8803 0.7059429465181 0.7059413373593099 -1.6875199384137202e-08 -0.09934172310620178 +1.8804 0.7059432996768391 0.7059416900452876 -2.0474909277583275e-08 -0.0993419224204643 +1.8805 0.7059436526902367 0.7059420426632426 -2.4078729927035775e-08 -0.09934212167457725 +1.8806 0.7059440055582912 0.7059423952132404 -2.7685831213535017e-08 -0.09934232086855867 +1.8807 0.7059443582810094 0.7059427476953386 -3.1295382517003076e-08 -0.09934252000242656 +1.8808000000000002 0.7059447108584076 0.7059431001095853 -3.490655289752238e-08 -0.09934271907619902 +1.8809 0.7059450632905108 0.7059434524560193 -3.851851128583005e-08 -0.09934291808989398 +1.881 0.7059454155773526 0.7059438047346711 -4.213042668541316e-08 -0.0993431170435295 +1.8811000000000002 0.705945767718976 0.705944156945562 -4.574146835260829e-08 -0.0993433159371236 +1.8812 0.7059461197154321 0.7059445090887045 -4.935080599103962e-08 -0.09934351477069422 +1.8813000000000002 0.7059464715667818 0.7059448611641024 -5.295760994528456e-08 -0.0993437135442594 +1.8814000000000002 0.7059468232730945 0.7059452131717499 -5.656105138743782e-08 -0.09934391225783713 +1.8815 0.7059471748344484 0.7059455651116328 -6.016030250940822e-08 -0.09934411091144535 +1.8816000000000002 0.7059475262509305 0.7059459169837282 -6.375453671632683e-08 -0.09934430950510209 +1.8817000000000002 0.7059478775226367 0.7059462687880041 -6.734292880587398e-08 -0.09934450803882532 +1.8818000000000001 0.7059482286496719 0.7059466205244195 -7.092465517102506e-08 -0.09934470651263294 +1.8819000000000001 0.7059485796321496 0.7059469721929248 -7.449889398176285e-08 -0.09934490492654295 +1.882 0.705948930470192 0.7059473237934616 -7.806482537047604e-08 -0.09934510328057329 +1.8821 0.7059492811639307 0.7059476753259628 -8.162163162971775e-08 -0.09934530157474199 +1.8822 0.7059496317135053 0.7059480267903524 -8.516849738827992e-08 -0.09934549980906694 +1.8823 0.7059499821190642 0.7059483781865455 -8.870460980765077e-08 -0.0993456979835661 +1.8824 0.7059503323807645 0.7059487295144489 -9.222915876242604e-08 -0.09934589609825734 +1.8825 0.7059506824987722 0.7059490807739606 -9.57413370285265e-08 -0.09934609415315865 +1.8826 0.7059510324732621 0.7059494319649697 -9.924034046621122e-08 -0.09934629214828798 +1.8827 0.7059513823044169 0.7059497830873573 -1.0272536820569306e-07 -0.09934649008366321 +1.8828000000000003 0.7059517319924282 0.705950134140995 -1.0619562283015194e-07 -0.09934668795930222 +1.8829 0.7059520815374962 0.7059504851257468 -1.0965031055788083e-07 -0.09934688577522298 +1.883 0.7059524309398295 0.7059508360414677 -1.1308864142182962e-07 -0.09934708353144335 +1.8831000000000002 0.7059527801996448 0.7059511868880046 -1.1650982945435318e-07 -0.09934728122798125 +1.8832 0.7059531293171677 0.7059515376651959 -1.1991309286675522e-07 -0.09934747886485458 +1.8833000000000002 0.7059534782926316 0.7059518883728717 -1.232976542132197e-07 -0.09934767644208124 +1.8834000000000002 0.7059538271262787 0.7059522390108535 -1.2666274060157967e-07 -0.09934787395967909 +1.8835 0.705954175818359 0.7059525895789548 -1.3000758382689104e-07 -0.09934807141766602 +1.8836000000000002 0.7059545243691308 0.7059529400769808 -1.3333142057959935e-07 -0.09934826881605988 +1.8837000000000002 0.7059548727788605 0.705953290504729 -1.366334926086038e-07 -0.09934846615487855 +1.8838000000000001 0.7059552210478226 0.7059536408619882 -1.3991304689299489e-07 -0.09934866343413991 +1.8839000000000001 0.7059555691763 0.7059539911485393 -1.4316933582073088e-07 -0.09934886065386178 +1.884 0.7059559171645826 0.7059543413641557 -1.4640161734996715e-07 -0.09934905781406206 +1.8841 0.7059562650129687 0.7059546915086023 -1.4960915517038542e-07 -0.09934925491475852 +1.8842 0.7059566127217649 0.705955041581637 -1.527912188957481e-07 -0.09934945195596909 +1.8843 0.7059569602912845 0.705955391583009 -1.5594708421134973e-07 -0.09934964893771153 +1.8844 0.7059573077218494 0.7059557415124602 -1.5907603303361162e-07 -0.09934984586000367 +1.8845 0.7059576550137889 0.7059560913697249 -1.6217735372171804e-07 -0.09935004272286346 +1.8846 0.7059580021674395 0.7059564411545298 -1.6525034114873993e-07 -0.09935023952630857 +1.8847 0.7059583491831454 0.7059567908665941 -1.6829429694623088e-07 -0.09935043627035685 +1.8848000000000003 0.7059586960612582 0.70595714050563 -1.7130852962045362e-07 -0.09935063295502619 +1.8849 0.7059590428021367 0.7059574900713415 -1.7429235473452598e-07 -0.09935082958033434 +1.885 0.7059593894061473 0.7059578395634256 -1.772450950350557e-07 -0.09935102614629904 +1.8851000000000002 0.7059597358736633 0.7059581889815725 -1.8016608062040862e-07 -0.09935122265293816 +1.8852 0.7059600822050649 0.7059585383254654 -1.8305464908816016e-07 -0.09935141910026946 +1.8853000000000002 0.7059604284007392 0.70595888759478 -1.8591014571203712e-07 -0.0993516154883107 +1.8854000000000002 0.7059607744610811 0.7059592367891852 -1.8873192353385804e-07 -0.0993518118170797 +1.8855 0.7059611203864915 0.7059595859083432 -1.9151934357169997e-07 -0.0993520080865942 +1.8856000000000002 0.7059614661773785 0.705959934951909 -1.942717749343903e-07 -0.09935220429687201 +1.8857000000000002 0.7059618118341564 0.7059602839195318 -1.9698859493946785e-07 -0.09935240044793087 +1.8858000000000001 0.7059621573572463 0.7059606328108532 -1.9966918931094146e-07 -0.0993525965397885 +1.8859000000000001 0.7059625027470758 0.7059609816255091 -2.0231295227643442e-07 -0.0993527925724627 +1.886 0.7059628480040792 0.7059613303631285 -2.0491928670596238e-07 -0.09935298854597116 +1.8861 0.7059631931286964 0.7059616790233343 -2.0748760427499735e-07 -0.0993531844603317 +1.8862 0.7059635381213738 0.7059620276057432 -2.1001732555814279e-07 -0.09935338031556197 +1.8863 0.7059638829825642 0.7059623761099658 -2.1250788021995315e-07 -0.09935357611167978 +1.8864 0.705964227712726 0.7059627245356067 -2.1495870704615894e-07 -0.09935377184870281 +1.8865 0.7059645723123237 0.7059630728822641 -2.1736925416224184e-07 -0.09935396752664877 +1.8866 0.7059649167818276 0.7059634211495314 -2.1973897912364038e-07 -0.09935416314553538 +1.8867 0.7059652611217134 0.7059637693369953 -2.2206734902677217e-07 -0.09935435870538041 +1.8868000000000003 0.7059656053324628 0.7059641174442374 -2.243538406374035e-07 -0.09935455420620147 +1.8869 0.7059659494145627 0.7059644654708337 -2.2659794051901883e-07 -0.09935474964801633 +1.887 0.7059662933685055 0.7059648134163548 -2.2879914513690425e-07 -0.09935494503084263 +1.8871000000000002 0.7059666371947887 0.705965161280366 -2.3095696096570029e-07 -0.09935514035469808 +1.8872 0.7059669808939153 0.7059655090624273 -2.3307090460389368e-07 -0.09935533561960036 +1.8873000000000002 0.7059673244663929 0.7059658567620939 -2.351405029091258e-07 -0.09935553082556713 +1.8874000000000002 0.7059676679127346 0.705966204378916 -2.3716529305370382e-07 -0.09935572597261612 +1.8875 0.7059680112334576 0.7059665519124387 -2.3914482266337855e-07 -0.09935592106076496 +1.8876000000000002 0.7059683544290848 0.7059668993622028 -2.4107864992489736e-07 -0.0993561160900313 +1.8877000000000002 0.7059686975001426 0.7059672467277438 -2.4296634364151526e-07 -0.0993563110604328 +1.8878000000000001 0.7059690404471626 0.7059675940085932 -2.4480748336483393e-07 -0.09935650597198714 +1.8879000000000001 0.7059693832706808 0.7059679412042785 -2.4660165949194623e-07 -0.09935670082471199 +1.888 0.7059697259712369 0.7059682883143217 -2.483484733487029e-07 -0.09935689561862489 +1.8881000000000001 0.7059700685493749 0.705968635338242 -2.500475372244071e-07 -0.09935709035374353 +1.8882 0.7059704110056435 0.7059689822755537 -2.516984745903894e-07 -0.09935728503008562 +1.8883 0.7059707533405943 0.7059693291257676 -2.5330092002714966e-07 -0.09935747964766865 +1.8884 0.7059710955547833 0.7059696758883904 -2.5485451941517634e-07 -0.09935767420651027 +1.8885 0.70597143764877 0.7059700225629254 -2.5635892995576337e-07 -0.09935786870662816 +1.8886 0.7059717796231175 0.7059703691488722 -2.5781382028203237e-07 -0.09935806314803991 +1.8887 0.7059721214783921 0.7059707156457271 -2.592188705283216e-07 -0.0993582575307631 +1.8888000000000003 0.7059724632151636 0.7059710620529833 -2.605737723475332e-07 -0.0993584518548154 +1.8889 0.7059728048340046 0.7059714083701298 -2.6187822904644165e-07 -0.09935864612021425 +1.889 0.7059731463354911 0.7059717545966542 -2.6313195564120484e-07 -0.09935884032697741 +1.8891000000000002 0.7059734877202019 0.7059721007320395 -2.6433467886430306e-07 -0.0993590344751223 +1.8892 0.7059738289887184 0.7059724467757672 -2.654861372790307e-07 -0.09935922856466661 +1.8893000000000002 0.7059741701416251 0.7059727927273155 -2.665860813350074e-07 -0.09935942259562788 +1.8894000000000002 0.7059745111795086 0.7059731385861603 -2.676342733820558e-07 -0.09935961656802372 +1.8895 0.7059748521029579 0.7059734843517749 -2.6863048773959064e-07 -0.09935981048187165 +1.8896000000000002 0.7059751929125646 0.7059738300236301 -2.69574510762538e-07 -0.09936000433718921 +1.8897 0.705975533608922 0.7059741756011955 -2.7046614089684673e-07 -0.09936019813399401 +1.8898000000000001 0.7059758741926256 0.7059745210839374 -2.713051886690798e-07 -0.09936039187230356 +1.8899000000000001 0.705976214664273 0.7059748664713212 -2.7209147675927303e-07 -0.0993605855521354 +1.89 0.7059765550244634 0.70597521176281 -2.728248400564459e-07 -0.09936077917350708 +1.8901000000000001 0.7059768952737975 0.7059755569578653 -2.7350512565166296e-07 -0.09936097273643614 +1.8902 0.7059772354128772 0.7059759020559476 -2.7413219290048363e-07 -0.0993611662409401 +1.8903 0.7059775754423063 0.7059762470565152 -2.747059134472485e-07 -0.09936135968703644 +1.8904 0.7059779153626895 0.7059765919590262 -2.752261712250792e-07 -0.0993615530747427 +1.8905 0.7059782551746328 0.7059769367629367 -2.7569286252179803e-07 -0.09936174640407643 +1.8906 0.7059785948787429 0.7059772814677021 -2.761058959764584e-07 -0.09936193967505512 +1.8907 0.7059789344756278 0.705977626072777 -2.7646519260016156e-07 -0.0993621328876962 +1.8908000000000003 0.7059792739658954 0.7059779705776158 -2.7677068575177044e-07 -0.09936232604201728 +1.8909 0.7059796133501549 0.7059783149816713 -2.7702232122464587e-07 -0.09936251913803579 +1.891 0.7059799526290154 0.7059786592843966 -2.772200572258299e-07 -0.0993627121757692 +1.8911000000000002 0.7059802918030866 0.7059790034852444 -2.773638643413512e-07 -0.09936290515523503 +1.8912 0.7059806308729781 0.7059793475836669 -2.774537255743892e-07 -0.09936309807645069 +1.8913000000000002 0.7059809698393 0.7059796915791168 -2.7748963636262114e-07 -0.09936329093943375 +1.8914000000000002 0.7059813087026616 0.7059800354710462 -2.7747160454005826e-07 -0.09936348374420156 +1.8915 0.7059816474636726 0.7059803792589083 -2.7739965036133185e-07 -0.09936367649077171 +1.8916000000000002 0.7059819861229415 0.7059807229421559 -2.7727380645312105e-07 -0.09936386917916151 +1.8917 0.7059823246810774 0.7059810665202425 -2.77094117869664e-07 -0.09936406180938849 +1.8918000000000001 0.7059826631386878 0.7059814099926223 -2.7686064198173543e-07 -0.09936425438147008 +1.8919000000000001 0.7059830014963799 0.7059817533587506 -2.765734485876692e-07 -0.09936444689542373 +1.892 0.7059833397547601 0.705982096618083 -2.7623261974682456e-07 -0.09936463935126688 +1.8921000000000001 0.7059836779144335 0.7059824397700762 -2.7583824988713923e-07 -0.09936483174901695 +1.8922 0.7059840159760038 0.7059827828141885 -2.7539044567675974e-07 -0.09936502408869134 +1.8923 0.7059843539400739 0.7059831257498789 -2.7488932608996097e-07 -0.09936521637030746 +1.8924 0.705984691807245 0.7059834685766084 -2.7433502232734885e-07 -0.09936540859388279 +1.8925 0.7059850295781165 0.7059838112938394 -2.7372767773953255e-07 -0.09936560075943468 +1.8926 0.7059853672532868 0.7059841539010354 -2.730674478687578e-07 -0.09936579286698055 +1.8927 0.7059857048333515 0.7059844963976627 -2.7235450037257913e-07 -0.0993659849165378 +1.8928000000000003 0.7059860423189054 0.7059848387831882 -2.715890149961042e-07 -0.09936617690812374 +1.8929 0.7059863797105403 0.7059851810570825 -2.7077118349913554e-07 -0.09936636884175591 +1.893 0.7059867170088463 0.705985523218817 -2.6990120963882314e-07 -0.09936656071745159 +1.8931000000000002 0.7059870542144107 0.7059858652678663 -2.689793090863979e-07 -0.09936675253522821 +1.8932 0.7059873913278187 0.7059862072037071 -2.6800570940288537e-07 -0.09936694429510311 +1.8933000000000002 0.7059877283496527 0.7059865490258186 -2.6698064999400306e-07 -0.09936713599709365 +1.8934000000000002 0.7059880652804926 0.7059868907336829 -2.6590438201648525e-07 -0.09936732764121725 +1.8935 0.7059884021209151 0.7059872323267847 -2.647771683295108e-07 -0.09936751922749118 +1.8936000000000002 0.705988738871494 0.7059875738046119 -2.635992834218448e-07 -0.09936771075593277 +1.8937 0.7059890755328009 0.705987915166655 -2.623710133702051e-07 -0.09936790222655947 +1.8938000000000001 0.7059894121054027 0.7059882564124087 -2.610926557629345e-07 -0.09936809363938856 +1.8939000000000001 0.7059897485898639 0.7059885975413702 -2.5976451962714253e-07 -0.0993682849944374 +1.894 0.7059900849867455 0.70598893855304 -2.583869253142135e-07 -0.09936847629172334 +1.8941000000000001 0.7059904212966046 0.7059892794469228 -2.569602044998065e-07 -0.09936866753126364 +1.8942 0.705990757519995 0.7059896202225266 -2.5548470002426105e-07 -0.0993688587130757 +1.8943 0.705991093657466 0.7059899608793633 -2.539607658717802e-07 -0.09936904983717676 +1.8944 0.7059914297095633 0.7059903014169485 -2.5238876706634716e-07 -0.09936924090358412 +1.8945 0.705991765676829 0.7059906418348024 -2.5076907956764205e-07 -0.09936943191231512 +1.8946 0.7059921015598005 0.7059909821324493 -2.491020902051222e-07 -0.09936962286338716 +1.8947 0.705992437359011 0.7059913223094169 -2.4738819655312216e-07 -0.09936981375681737 +1.8948000000000003 0.7059927730749891 0.705991662365238 -2.4562780686493424e-07 -0.0993700045926231 +1.8949 0.7059931087082596 0.7059920022994498 -2.4382133996525557e-07 -0.09937019537082165 +1.895 0.705993444259342 0.7059923421115941 -2.4196922517732977e-07 -0.09937038609143029 +1.8951000000000002 0.705993779728751 0.7059926818012174 -2.400719021806996e-07 -0.09937057675446627 +1.8952 0.7059941151169973 0.7059930213678713 -2.3812982092447088e-07 -0.09937076735994695 +1.8953000000000002 0.7059944504245856 0.7059933608111117 -2.3614344150935107e-07 -0.09937095790788952 +1.8954000000000002 0.7059947856520159 0.7059937001305002 -2.3411323411132168e-07 -0.09937114839831122 +1.8955 0.7059951207997834 0.7059940393256032 -2.3203967882898247e-07 -0.09937133883122935 +1.8956000000000002 0.7059954558683776 0.7059943783959923 -2.2992326560722365e-07 -0.09937152920666112 +1.8957 0.7059957908582826 0.7059947173412449 -2.2776449409497856e-07 -0.0993717195246238 +1.8958000000000002 0.7059961257699775 0.7059950561609433 -2.2556387353420138e-07 -0.09937190978513465 +1.8959000000000001 0.7059964606039351 0.7059953948546759 -2.233219226523142e-07 -0.09937209998821085 +1.896 0.7059967953606228 0.7059957334220366 -2.2103916952342928e-07 -0.09937229013386967 +1.8961000000000001 0.7059971300405026 0.7059960718626246 -2.187161514365099e-07 -0.0993724802221283 +1.8962 0.7059974646440301 0.7059964101760454 -2.16353414798226e-07 -0.09937267025300395 +1.8963 0.7059977991716553 0.705996748361911 -2.1395151499764564e-07 -0.09937286022651391 +1.8964 0.7059981336238217 0.7059970864198382 -2.1151101624664048e-07 -0.09937305014267528 +1.8965 0.7059984680009671 0.7059974243494511 -2.090324915000885e-07 -0.09937324000150538 +1.8966 0.7059988023035229 0.7059977621503796 -2.06516522261585e-07 -0.09937342980302137 +1.8967 0.7059991365319136 0.7059980998222594 -2.0396369849323692e-07 -0.09937361954724036 +1.8968000000000003 0.7059994706865582 0.7059984373647334 -2.0137461843178217e-07 -0.09937380923417961 +1.8969 0.7059998047678686 0.7059987747774508 -1.9874988851226183e-07 -0.09937399886385628 +1.897 0.70600013877625 0.7059991120600673 -1.960901231598533e-07 -0.09937418843628756 +1.8971000000000002 0.7060004727121012 0.7059994492122452 -1.933959446927258e-07 -0.09937437795149062 +1.8972 0.7060008065758141 0.7059997862336536 -1.9066798316938471e-07 -0.09937456740948261 +1.8973000000000002 0.7060011403677737 0.7060001231239688 -1.879068762082603e-07 -0.09937475681028068 +1.8974000000000002 0.7060014740883582 0.7060004598828737 -1.8511326889750213e-07 -0.09937494615390208 +1.8975 0.706001807737939 0.7060007965100581 -1.8228781357293444e-07 -0.09937513544036389 +1.8976000000000002 0.7060021413168797 0.7060011330052189 -1.7943116972091167e-07 -0.09937532466968324 +1.8977 0.7060024748255369 0.7060014693680603 -1.7654400380831548e-07 -0.09937551384187727 +1.8978000000000002 0.7060028082642607 0.7060018055982937 -1.7362698911255192e-07 -0.09937570295696314 +1.8979000000000001 0.706003141633393 0.7060021416956381 -1.706808055879777e-07 -0.099375892014958 +1.898 0.7060034749332689 0.7060024776598192 -1.677061396872237e-07 -0.09937608101587897 +1.8981000000000001 0.7060038081642158 0.7060028134905705 -1.6470368422588644e-07 -0.09937626995974311 +1.8982 0.7060041413265538 0.7060031491876327 -1.616741381986475e-07 -0.0993764588465676 +1.8983 0.7060044744205949 0.7060034847507547 -1.5861820662661785e-07 -0.0993766476763695 +1.8984 0.7060048074466442 0.7060038201796928 -1.555366003908043e-07 -0.099376836449166 +1.8985 0.7060051404049987 0.7060041554742105 -1.5243003605169836e-07 -0.0993770251649742 +1.8986 0.7060054732959471 0.7060044906340794 -1.4929923571917192e-07 -0.09937721382381107 +1.8987 0.7060058061197714 0.7060048256590792 -1.4614492685818825e-07 -0.09937740242569382 +1.8988000000000003 0.7060061388767447 0.7060051605489968 -1.429678421187991e-07 -0.09937759097063947 +1.8989 0.7060064715671327 0.7060054953036277 -1.3976871917134592e-07 -0.09937777945866513 +1.899 0.7060068041911931 0.7060058299227747 -1.3654830055033484e-07 -0.09937796788978788 +1.8991000000000002 0.7060071367491758 0.7060061644062491 -1.3330733344973922e-07 -0.09937815626402478 +1.8992 0.7060074692413219 0.70600649875387 -1.300465695859565e-07 -0.09937834458139289 +1.8993000000000002 0.7060078016678648 0.7060068329654651 -1.267667650000498e-07 -0.09937853284190931 +1.8994000000000002 0.70600813402903 0.7060071670408693 -1.2346867988601018e-07 -0.09937872104559103 +1.8995 0.7060084663250342 0.7060075009799265 -1.2015307841554967e-07 -0.09937890919245514 +1.8996000000000002 0.7060087985560863 0.7060078347824884 -1.1682072856636361e-07 -0.09937909728251866 +1.8997 0.7060091307223871 0.7060081684484155 -1.1347240194345409e-07 -0.09937928531579869 +1.8998000000000002 0.7060094628241284 0.7060085019775761 -1.1010887358831045e-07 -0.09937947329231223 +1.8999000000000001 0.7060097948614938 0.706008835369847 -1.0673092181064103e-07 -0.09937966121207628 +1.9 0.706010126834659 0.7060091686251135 -1.0333932801837031e-07 -0.09937984907510791 +1.9001000000000001 0.7060104587437906 0.7060095017432692 -9.993487650947208e-08 -0.09938003688142412 +1.9002000000000001 0.7060107905890476 0.7060098347242161 -9.651835431844641e-08 -0.09938022463104194 +1.9003 0.7060111223705796 0.7060101675678643 -9.309055101682645e-08 -0.09938041232397835 +1.9004 0.7060114540885283 0.7060105002741333 -8.965225853450193e-08 -0.09938059996025037 +1.9005 0.7060117857430268 0.7060108328429504 -8.620427098364469e-08 -0.099380787539875 +1.9006 0.7060121173341991 0.7060111652742516 -8.274738446962387e-08 -0.09938097506286922 +1.9007 0.7060124488621613 0.7060114975679816 -7.928239690885991e-08 -0.09938116252925004 +1.9008000000000003 0.7060127803270206 0.7060118297240936 -7.581010783887232e-08 -0.09938134993903443 +1.9009 0.7060131117288759 0.7060121617425491 -7.233131824480737e-08 -0.09938153729223938 +1.901 0.7060134430678169 0.7060124936233186 -6.884683036645009e-08 -0.09938172458888185 +1.9011000000000002 0.7060137743439254 0.7060128253663811 -6.535744751607828e-08 -0.09938191182897883 +1.9012 0.7060141055572737 0.7060131569717241 -6.186397389284712e-08 -0.09938209901254724 +1.9013000000000002 0.7060144367079264 0.706013488439344 -5.836721439804113e-08 -0.09938228613960415 +1.9014000000000002 0.706014767795939 0.7060138197692456 -5.4867974449241894e-08 -0.09938247321016647 +1.9015 0.706015098821358 0.706014150961442 -5.1367059794929504e-08 -0.09938266022425109 +1.9016000000000002 0.7060154297842218 0.706014482015956 -4.78652763297345e-08 -0.09938284718187504 +1.9017 0.7060157606845598 0.7060148129328174 -4.436342990714196e-08 -0.09938303408305516 +1.9018000000000002 0.7060160915223932 0.7060151437120662 -4.086232615439783e-08 -0.09938322092780845 +1.9019000000000001 0.7060164222977336 0.7060154743537501 -3.736277029214516e-08 -0.09938340771615183 +1.902 0.7060167530105852 0.706015804857926 -3.386556694166647e-08 -0.09938359444810219 +1.9021000000000001 0.7060170836609427 0.7060161352246588 -3.037151994483844e-08 -0.09938378112367648 +1.9022000000000001 0.7060174142487925 0.7060164654540226 -2.6881432178956985e-08 -0.09938396774289163 +1.9023 0.7060177447741125 0.7060167955460998 -2.339610536902792e-08 -0.09938415430576454 +1.9024 0.7060180752368714 0.7060171255009811 -1.991633990974101e-08 -0.09938434081231208 +1.9025 0.7060184056370302 0.7060174553187664 -1.644293467530089e-08 -0.09938452726255118 +1.9026 0.7060187359745409 0.7060177849995635 -1.2976686840967394e-08 -0.09938471365649874 +1.9027 0.7060190662493465 0.7060181145434893 -9.518391696789613e-09 -0.09938489999417163 +1.9028000000000003 0.7060193964613826 0.7060184439506687 -6.068842467628344e-09 -0.09938508627558675 +1.9029 0.706019726610575 0.7060187732212353 -2.628830128408033e-09 -0.09938527250076096 +1.903 0.7060200566968424 0.7060191023553313 8.008567689218871e-10 -0.09938545866971117 +1.9031000000000002 0.7060203867200939 0.7060194313531067 4.219432294880199e-09 -0.09938564478245421 +1.9032 0.7060207166802308 0.7060197602147209 7.626113296410608e-09 -0.09938583083900693 +1.9033000000000002 0.7060210465771459 0.7060200889403407 1.1020119600711753e-08 -0.09938601683938626 +1.9034 0.7060213764107238 0.7060204175301419 1.4400674175699124e-08 -0.09938620278360902 +1.9035 0.7060217061808405 0.706020745984308 1.776700332169201e-08 -0.09938638867169204 +1.9036000000000002 0.7060220358873641 0.7060210743030311 2.1118336831875417e-08 -0.09938657450365222 +1.9037 0.7060223655301537 0.7060214024865115 2.4453908193527996e-08 -0.09938676027950631 +1.9038000000000002 0.7060226951090613 0.7060217305349579 2.7772954729402e-08 -0.09938694599927123 +1.9039000000000001 0.7060230246239301 0.7060220584485863 3.1074717805890106e-08 -0.09938713166296377 +1.904 0.7060233540745954 0.7060223862276216 3.4358442988283167e-08 -0.09938731727060077 +1.9041000000000001 0.7060236834608842 0.7060227138722963 3.7623380215109914e-08 -0.09938750282219902 +1.9042000000000001 0.706024012782616 0.7060230413828512 4.086878396640514e-08 -0.09938768831777536 +1.9043 0.7060243420396017 0.7060233687595348 4.409391344412095e-08 -0.09938787375734659 +1.9044 0.706024671231645 0.7060236960026034 4.729803272998656e-08 -0.09938805914092955 +1.9045 0.7060250003585411 0.7060240231123214 5.048041096245015e-08 -0.09938824446854096 +1.9046 0.7060253294200778 0.7060243500889607 5.36403224980081e-08 -0.09938842974019768 +1.9047 0.7060256584160353 0.7060246769328011 5.677704707079956e-08 -0.09938861495591648 +1.9048000000000003 0.7060259873461856 0.7060250036441303 5.98898699730177e-08 -0.09938880011571419 +1.9049 0.7060263162102935 0.7060253302232429 6.297808221103485e-08 -0.09938898521960748 +1.905 0.7060266450081167 0.7060256566704413 6.604098064764974e-08 -0.09938917026761325 +1.9051000000000002 0.7060269737394045 0.7060259829860356 6.907786819811135e-08 -0.09938935525974821 +1.9052 0.706027302403899 0.7060263091703431 7.208805395848839e-08 -0.0993895401960291 +1.9053000000000002 0.7060276310013355 0.7060266352236884 7.507085337046804e-08 -0.0993897250764727 +1.9054 0.7060279595314415 0.7060269611464036 7.802558839309359e-08 -0.0993899099010958 +1.9055 0.7060282879939377 0.7060272869388278 8.095158763460342e-08 -0.09939009466991511 +1.9056000000000002 0.706028616388537 0.706027612601307 8.384818650855608e-08 -0.09939027938294738 +1.9057 0.7060289447149461 0.7060279381341943 8.67147273934249e-08 -0.09939046404020932 +1.9058000000000002 0.7060292729728643 0.7060282635378504 8.955055979045778e-08 -0.09939064864171775 +1.9059000000000001 0.7060296011619838 0.7060285888126421 9.2355040438169e-08 -0.09939083318748929 +1.906 0.7060299292819905 0.7060289139589435 9.512753351009762e-08 -0.09939101767754079 +1.9061000000000001 0.7060302573325631 0.7060292389771349 9.786741069980898e-08 -0.09939120211188887 +1.9062000000000001 0.7060305853133739 0.7060295638676037 1.0057405140304065e-07 -0.09939138649055032 +1.9063 0.7060309132240886 0.7060298886307438 1.0324684284954144e-07 -0.09939157081354179 +1.9064 0.7060312410643661 0.7060302132669551 1.0588518024184923e-07 -0.09939175508087998 +1.9065 0.7060315688338596 0.7060305377766445 1.0848846685937441e-07 -0.09939193929258162 +1.9066 0.7060318965322152 0.7060308621602249 1.1105611426309725e-07 -0.09939212344866345 +1.9067 0.7060322241590734 0.7060311864181155 1.1358754237536517e-07 -0.09939230754914209 +1.9068000000000003 0.7060325517140682 0.7060315105507413 1.1608217960826228e-07 -0.09939249159403425 +1.9069 0.7060328791968276 0.7060318345585339 1.185394630197345e-07 -0.09939267558335661 +1.907 0.7060332066069739 0.7060321584419301 1.2095883843155075e-07 -0.09939285951712584 +1.9071000000000002 0.7060335339441233 0.7060324822013733 1.2333976054726414e-07 -0.09939304339535865 +1.9072 0.7060338612078865 0.706032805837312 1.2568169308058152e-07 -0.09939322721807167 +1.9073000000000002 0.706034188397868 0.7060331293502005 1.2798410888720246e-07 -0.09939341098528154 +1.9074 0.7060345155136679 0.7060334527404987 1.3024649004461653e-07 -0.09939359469700497 +1.9075 0.7060348425548796 0.7060337760086721 1.3246832801516728e-07 -0.09939377835325858 +1.9076000000000002 0.7060351695210916 0.7060340991551912 1.3464912373278848e-07 -0.09939396195405902 +1.9077 0.7060354964118872 0.7060344221805319 1.367883877174958e-07 -0.0993941454994229 +1.9078000000000002 0.7060358232268449 0.7060347450851752 1.3888564021416472e-07 -0.09939432898936688 +1.9079000000000002 0.7060361499655374 0.7060350678696073 1.4094041125151113e-07 -0.09939451242390761 +1.908 0.7060364766275333 0.7060353905343191 1.4295224078433866e-07 -0.0993946958030617 +1.9081000000000001 0.7060368032123958 0.7060357130798061 1.4492067876986647e-07 -0.09939487912684579 +1.9082000000000001 0.7060371297196835 0.7060360355065689 1.468452852995683e-07 -0.09939506239527644 +1.9083 0.7060374561489505 0.7060363578151125 1.4872563067203082e-07 -0.09939524560837032 +1.9084 0.7060377824997467 0.7060366800059463 1.505612954900981e-07 -0.09939542876614402 +1.9085 0.7060381087716171 0.7060370020795843 1.5235187076495516e-07 -0.09939561186861415 +1.9086 0.7060384349641027 0.7060373240365445 1.5409695800980283e-07 -0.0993957949157973 +1.9087 0.7060387610767399 0.7060376458773492 1.55796169302308e-07 -0.09939597790771003 +1.9088000000000003 0.7060390871090618 0.7060379676025246 1.574491274268508e-07 -0.09939616084436896 +1.9089 0.7060394130605971 0.7060382892126008 1.5905546588493302e-07 -0.09939634372579066 +1.909 0.706039738930871 0.7060386107081118 1.6061482903048652e-07 -0.0993965265519917 +1.9091000000000002 0.706040064719405 0.7060389320895955 1.621268721357927e-07 -0.09939670932298872 +1.9092 0.7060403904257162 0.7060392533575928 1.635912614504631e-07 -0.09939689203879822 +1.9093000000000002 0.7060407160493195 0.7060395745126482 1.6500767430205343e-07 -0.09939707469943677 +1.9094 0.7060410415897256 0.7060398955553098 1.663757991203496e-07 -0.09939725730492092 +1.9095 0.706041367046442 0.7060402164861288 1.6769533557961513e-07 -0.09939743985526726 +1.9096000000000002 0.7060416924189741 0.7060405373056593 1.6896599458818273e-07 -0.09939762235049232 +1.9097 0.706042017706823 0.7060408580144585 1.7018749839600722e-07 -0.09939780479061265 +1.9098000000000002 0.7060423429094875 0.7060411786130864 1.7135958065711554e-07 -0.09939798717564473 +1.9099000000000002 0.706042668026464 0.7060414991021056 1.7248198645042345e-07 -0.09939816950560515 +1.91 0.7060429930572458 0.7060418194820814 1.7355447239075783e-07 -0.09939835178051046 +1.9101000000000001 0.7060433180013242 0.7060421397535817 1.7457680663579556e-07 -0.09939853400037713 +1.9102000000000001 0.7060436428581878 0.7060424599171764 1.7554876895545246e-07 -0.09939871616522172 +1.9103 0.7060439676273228 0.7060427799734376 1.7647015075616945e-07 -0.09939889827506067 +1.9104 0.7060442923082141 0.7060430999229399 1.7734075516417924e-07 -0.0993990803299106 +1.9105 0.7060446169003436 0.7060434197662598 1.781603970289758e-07 -0.09939926232978792 +1.9106 0.7060449414031917 0.706043739503975 1.7892890296841713e-07 -0.09939944427470915 +1.9107 0.7060452658162376 0.7060440591366659 1.7964611147627818e-07 -0.0993996261646908 +1.9108000000000003 0.7060455901389584 0.7060443786649133 1.803118728389841e-07 -0.09939980799974935 +1.9109 0.70604591437083 0.7060446980893007 1.809260492570408e-07 -0.09939998977990129 +1.911 0.7060462385113265 0.7060450174104121 1.814885148276879e-07 -0.09940017150516313 +1.9111000000000002 0.7060465625599213 0.7060453366288328 1.8199915557612356e-07 -0.09940035317555128 +1.9112 0.7060468865160865 0.7060456557451493 1.8245786949019904e-07 -0.09940053479108227 +1.9113000000000002 0.706047210379293 0.7060459747599493 1.828645665273576e-07 -0.09940071635177251 +1.9114 0.7060475341490109 0.7060462936738208 1.8321916865279841e-07 -0.09940089785763846 +1.9115 0.7060478578247108 0.7060466124873526 1.8352160983600707e-07 -0.09940107930869667 +1.9116000000000002 0.7060481814058612 0.7060469312011343 1.8377183607851122e-07 -0.0994012607049635 +1.9117 0.7060485048919305 0.7060472498157556 1.839698053965333e-07 -0.0994014420464554 +1.9118000000000002 0.7060488282823871 0.7060475683318068 1.841154878418072e-07 -0.0994016233331888 +1.9119000000000002 0.7060491515766993 0.7060478867498786 1.8420886550157833e-07 -0.0994018045651802 +1.912 0.7060494747743351 0.706048205070561 1.8424993251248134e-07 -0.09940198574244599 +1.9121000000000001 0.7060497978747624 0.706048523294444 1.842386950501318e-07 -0.09940216686500256 +1.9122000000000001 0.7060501208774499 0.7060488414221182 1.8417517130137062e-07 -0.09940234793286638 +1.9123 0.706050443781866 0.7060491594541731 1.8405939150589745e-07 -0.09940252894605384 +1.9124 0.70605076658748 0.7060494773911978 1.8389139790422893e-07 -0.09940270990458139 +1.9125 0.7060510892937618 0.7060497952337812 1.8367124474116814e-07 -0.0994028908084654 +1.9126 0.7060514119001817 0.706050112982511 1.8339899823111017e-07 -0.09940307165772229 +1.9127 0.7060517344062109 0.7060504306379742 1.8307473656151152e-07 -0.09940325245236845 +1.9128000000000003 0.7060520568113218 0.7060507482007569 1.82698549868604e-07 -0.09940343319242023 +1.9129 0.7060523791149877 0.7060510656714439 1.8227054023045586e-07 -0.09940361387789412 +1.913 0.7060527013166835 0.706051383050619 1.8179082156982718e-07 -0.09940379450880639 +1.9131000000000002 0.7060530234158847 0.706051700338864 1.8125951971315057e-07 -0.09940397508517346 +1.9132 0.7060533454120692 0.7060520175367603 1.8067677229338663e-07 -0.09940415560701171 +1.9133000000000002 0.706053667304716 0.7060523346448866 1.8004272873961558e-07 -0.0994043360743375 +1.9134 0.7060539890933057 0.7060526516638204 1.7935755025969002e-07 -0.0994045164871672 +1.9135 0.7060543107773215 0.7060529685941372 1.7862140976390717e-07 -0.09940469684551717 +1.9136000000000002 0.7060546323562474 0.7060532854364108 1.7783449185113098e-07 -0.09940487714940376 +1.9137 0.7060549538295708 0.706053602191212 1.7699699272205605e-07 -0.09940505739884334 +1.9138000000000002 0.7060552751967801 0.7060539188591104 1.7610912015839086e-07 -0.0994052375938522 +1.9139000000000002 0.7060555964573669 0.7060542354406725 1.7517109348469395e-07 -0.09940541773444665 +1.914 0.7060559176108255 0.7060545519364623 1.7418314350939323e-07 -0.09940559782064312 +1.9141000000000001 0.706056238656652 0.7060548683470417 1.7314551244151932e-07 -0.0994057778524579 +1.9142000000000001 0.7060565595943458 0.7060551846729695 1.7205845383519436e-07 -0.0994059578299073 +1.9143000000000001 0.7060568804234086 0.7060555009148017 1.7092223256881534e-07 -0.09940613775300766 +1.9144 0.7060572011433458 0.7060558170730911 1.697371247409707e-07 -0.09940631762177525 +1.9145 0.7060575217536655 0.7060561331483877 1.685034176183986e-07 -0.09940649743622643 +1.9146 0.7060578422538786 0.7060564491412382 1.6722140956659803e-07 -0.09940667719637745 +1.9147 0.7060581626435003 0.7060567650521861 1.658914099630926e-07 -0.09940685690224468 +1.9148000000000003 0.7060584829220484 0.706057080881771 1.6451373915579715e-07 -0.09940703655384436 +1.9149 0.7060588030890447 0.706057396630529 1.6308872833811772e-07 -0.0994072161511928 +1.915 0.7060591231440145 0.7060577122989933 1.6161671950731815e-07 -0.0994073956943063 +1.9151000000000002 0.706059443086487 0.7060580278876918 1.600980654055395e-07 -0.09940757518320108 +1.9152 0.7060597629159951 0.7060583433971501 1.5853312934979713e-07 -0.0994077546178935 +1.9153000000000002 0.7060600826320761 0.7060586588278889 1.5692228522851126e-07 -0.09940793399839978 +1.9154 0.7060604022342709 0.7060589741804245 1.5526591735925965e-07 -0.0994081133247362 +1.9155 0.7060607217221251 0.7060592894552695 1.535644204506137e-07 -0.099408292596919 +1.9156000000000002 0.7060610410951883 0.7060596046529319 1.5181819946682995e-07 -0.09940847181496444 +1.9157 0.7060613603530151 0.7060599197739154 1.5002766952029734e-07 -0.09940865097888882 +1.9158000000000002 0.7060616794951642 0.7060602348187188 1.481932558125565e-07 -0.09940883008870832 +1.9159000000000002 0.7060619985211987 0.7060605497878365 1.4631539351286915e-07 -0.09940900914443922 +1.916 0.706062317430687 0.7060608646817581 1.443945276506653e-07 -0.09940918814609774 +1.9161000000000001 0.7060626362232028 0.7060611795009678 1.4243111304268474e-07 -0.09940936709370012 +1.9162000000000001 0.7060629548983237 0.7060614942459456 1.4042561413338261e-07 -0.09940954598726259 +1.9163000000000001 0.7060632734556331 0.7060618089171655 1.383785048977848e-07 -0.09940972482680138 +1.9164 0.7060635918947193 0.7060621235150972 1.3629026878597683e-07 -0.09940990361233268 +1.9165 0.7060639102151762 0.7060624380402043 1.341613985496315e-07 -0.09941008234387272 +1.9166 0.706064228416603 0.7060627524929456 1.3199239612751712e-07 -0.09941026102143773 +1.9167 0.7060645464986041 0.7060630668737741 1.2978377256223084e-07 -0.09941043964504387 +1.9168000000000003 0.7060648644607894 0.7060633811831368 1.2753604783713457e-07 -0.09941061821470731 +1.9169 0.7060651823027753 0.7060636954214761 1.2524975081043555e-07 -0.09941079673044434 +1.917 0.7060655000241832 0.7060640095892275 1.2292541904171395e-07 -0.09941097519227109 +1.9171 0.7060658176246404 0.7060643236868211 1.2056359867396171e-07 -0.09941115360020371 +1.9172 0.7060661351037807 0.7060646377146813 1.1816484430174357e-07 -0.09941133195425844 +1.9173000000000002 0.7060664524612434 0.7060649516732259 1.1572971888793027e-07 -0.09941151025445145 +1.9174 0.706066769696674 0.706065265562867 1.1325879357287905e-07 -0.09941168850079893 +1.9175 0.7060670868097247 0.7060655793840098 1.1075264757381964e-07 -0.09941186669331697 +1.9176000000000002 0.7060674038000534 0.706065893137054 1.0821186801832083e-07 -0.09941204483202176 +1.9177 0.7060677206673246 0.7060662068223924 1.0563704986102374e-07 -0.09941222291692947 +1.9178000000000002 0.7060680374112093 0.7060665204404114 1.0302879569976109e-07 -0.09941240094805621 +1.9179000000000002 0.7060683540313851 0.7060668339914911 1.0038771562637105e-07 -0.09941257892541822 +1.918 0.7060686705275361 0.7060671474760044 9.771442711567491e-08 -0.0994127568490315 +1.9181000000000001 0.7060689868993533 0.706067460894318 9.500955487282137e-08 -0.09941293471891231 +1.9182000000000001 0.7060693031465344 0.7060677742467919 9.227373069797817e-08 -0.09941311253507673 +1.9183000000000001 0.7060696192687836 0.7060680875337785 8.950759328510416e-08 -0.09941329029754091 +1.9184 0.7060699352658127 0.7060684007556237 8.671178815256031e-08 -0.09941346800632091 +1.9185 0.7060702511373398 0.7060687139126667 8.388696742626933e-08 -0.09941364566143289 +1.9186 0.7060705668830908 0.7060690270052391 8.103378974083641e-08 -0.099413823262893 +1.9187 0.7060708825027979 0.7060693400336655 7.815292003485186e-08 -0.09941400081071727 +1.9188000000000003 0.7060711979962013 0.7060696529982635 7.524502942599098e-08 -0.09941417830492183 +1.9189 0.706071513363048 0.7060699658993432 7.231079505662374e-08 -0.09941435574552282 +1.919 0.7060718286030921 0.7060702787372075 6.935089992554655e-08 -0.09941453313253629 +1.9191 0.706072143716096 0.7060705915121517 6.636603271797936e-08 -0.09941471046597836 +1.9192 0.7060724587018284 0.7060709042244635 6.335688768066561e-08 -0.09941488774586507 +1.9193000000000002 0.7060727735600666 0.7060712168744239 6.032416443278732e-08 -0.09941506497221257 +1.9194 0.7060730882905946 0.7060715294623052 5.726856780984002e-08 -0.09941524214503686 +1.9195 0.7060734028932042 0.7060718419883727 5.419080769536455e-08 -0.099415419264354 +1.9196000000000002 0.7060737173676954 0.7060721544528838 5.109159887002612e-08 -0.09941559633018011 +1.9197 0.7060740317138754 0.7060724668560889 4.7971660834672525e-08 -0.09941577334253124 +1.9198000000000002 0.7060743459315589 0.7060727791982295 4.483171763165761e-08 -0.09941595030142342 +1.9199000000000002 0.7060746600205693 0.7060730914795399 4.1672497711267575e-08 -0.09941612720687269 +1.92 0.7060749739807373 0.7060734037002463 3.8494733728758335e-08 -0.09941630405889515 +1.9201000000000001 0.7060752878119013 0.7060737158605672 3.5299162396904005e-08 -0.0994164808575068 +1.9202000000000001 0.706075601513908 0.7060740279607128 3.208652428997316e-08 -0.09941665760272364 +1.9203000000000001 0.7060759150866123 0.7060743400008858 2.885756370842041e-08 -0.09941683429456177 +1.9204 0.7060762285298764 0.7060746519812804 2.5613028475923727e-08 -0.09941701093303718 +1.9205 0.7060765418435713 0.7060749639020831 2.2353669778055196e-08 -0.09941718751816592 +1.9206 0.7060768550275754 0.7060752757634718 1.9080241990543367e-08 -0.09941736404996399 +1.9207 0.7060771680817759 0.706075587565617 1.5793502498862022e-08 -0.09941754052844737 +1.9208000000000003 0.7060774810060677 0.7060758993086802 1.2494211521288379e-08 -0.0994177169536321 +1.9209 0.7060777938003537 0.7060762109928151 9.183131949308532e-09 -0.09941789332553415 +1.921 0.706078106464546 0.7060765226181678 5.861029153328423e-09 -0.0994180696441696 +1.9211 0.7060784189985639 0.7060768341848748 2.5286708074667708e-09 -0.09941824590955439 +1.9212 0.7060787314023351 0.7060771456930656 -8.131732787131085e-10 -0.09941842212170449 +1.9213000000000002 0.7060790436757958 0.7060774571428603 -4.16373133541037e-09 -0.09941859828063587 +1.9214 0.7060793558188907 0.7060777685343718 -7.522229830345117e-09 -0.0994187743863646 +1.9215 0.7060796678315725 0.7060780798677038 -1.0887893630087686e-08 -0.09941895043890653 +1.9216000000000002 0.7060799797138023 0.706078391142952 -1.4259946180469885e-08 -0.09941912643827772 +1.9217 0.7060802914655493 0.7060787023602041 -1.7637609690032002e-08 -0.09941930238449409 +1.9218000000000002 0.7060806030867914 0.7060790135195387 -2.1020105311735093e-08 -0.09941947827757161 +1.9219000000000002 0.7060809145775151 0.7060793246210266 -2.4406653311662835e-08 -0.09941965411752629 +1.922 0.7060812259377145 0.7060796356647299 -2.7796473262009513e-08 -0.099419829904374 +1.9221000000000001 0.7060815371673924 0.7060799466507026 -3.1188784210649245e-08 -0.09942000563813069 +1.9222000000000001 0.7060818482665605 0.70608025757899 -3.458280486761875e-08 -0.09942018131881236 +1.9223000000000001 0.706082159235238 0.7060805684496292 -3.797775378097494e-08 -0.09942035694643492 +1.9224 0.7060824700734529 0.7060808792626487 -4.137284951796511e-08 -0.09942053252101427 +1.9225 0.7060827807812418 0.706081190018069 -4.476731084633264e-08 -0.09942070804256635 +1.9226 0.7060830913586496 0.7060815007159019 -4.816035691036433e-08 -0.09942088351110712 +1.9227 0.7060834018057289 0.7060818113561509 -5.155120741417475e-08 -0.09942105892665243 +1.9228000000000003 0.7060837121225414 0.7060821219388111 -5.49390827987023e-08 -0.09942123428921826 +1.9229 0.7060840223091571 0.7060824324638695 -5.8323204422689595e-08 -0.09942140959882051 +1.923 0.7060843323656538 0.7060827429313041 -6.170279473818874e-08 -0.09942158485547503 +1.9231 0.7060846422921181 0.7060830533410855 -6.507707747595987e-08 -0.0994217600591978 +1.9232 0.7060849520886447 0.7060833636931749 -6.844527781742563e-08 -0.0994219352100046 +1.9233000000000002 0.7060852617553366 0.7060836739875264 -7.180662256901088e-08 -0.0994221103079114 +1.9234 0.7060855712923051 0.7060839842240848 -7.516034035296229e-08 -0.0994222853529341 +1.9235 0.7060858806996698 0.7060842944027872 -7.850566177605017e-08 -0.09942246034508853 +1.9236000000000002 0.7060861899775585 0.7060846045235623 -8.1841819597403e-08 -0.09942263528439059 +1.9237 0.7060864991261068 0.7060849145863302 -8.51680489232301e-08 -0.09942281017085608 +1.9238000000000002 0.7060868081454592 0.7060852245910039 -8.848358736424783e-08 -0.09942298500450099 +1.9239000000000002 0.7060871170357679 0.7060855345374869 -9.178767522259601e-08 -0.0994231597853411 +1.924 0.7060874257971931 0.7060858444256755 -9.507955566531029e-08 -0.09942333451339225 +1.9241000000000001 0.7060877344299032 0.7060861542554577 -9.835847488478405e-08 -0.09942350918867034 +1.9242000000000001 0.7060880429340749 0.7060864640267133 -1.0162368228872065e-07 -0.0994236838111912 +1.9243000000000001 0.7060883513098924 0.7060867737393144 -1.0487443065625851e-07 -0.09942385838097066 +1.9244 0.7060886595575484 0.7060870833931243 -1.081099763244539e-07 -0.09942403289802455 +1.9245 0.706088967677243 0.7060873929879998 -1.1132957934006926e-07 -0.09942420736236877 +1.9246 0.7060892756691847 0.7060877025237884 -1.1453250365472956e-07 -0.09942438177401909 +1.9247 0.7060895835335892 0.7060880120003302 -1.177180172541592e-07 -0.09942455613299131 +1.9248000000000003 0.706089891270681 0.706088321417458 -1.208853923680836e-07 -0.09942473043930135 +1.9249 0.7060901988806911 0.7060886307749958 -1.240339056116091e-07 -0.09942490469296489 +1.925 0.7060905063638591 0.706088940072761 -1.271628381413481e-07 -0.09942507889399779 +1.9251 0.7060908137204317 0.7060892493105628 -1.3027147586185117e-07 -0.09942525304241585 +1.9252 0.7060911209506637 0.7060895584882028 -1.333591095348946e-07 -0.09942542713823492 +1.9253000000000002 0.7060914280548172 0.7060898676054749 -1.3642503497897362e-07 -0.09942560118147076 +1.9254 0.7060917350331617 0.7060901766621659 -1.3946855322022333e-07 -0.09942577517213914 +1.9255 0.7060920418859742 0.7060904856580548 -1.4248897062946186e-07 -0.0994259491102559 +1.9256000000000002 0.7060923486135393 0.7060907945929134 -1.4548559912688774e-07 -0.09942612299583677 +1.9257 0.7060926552161483 0.706091103466506 -1.4845775629136748e-07 -0.09942629682889753 +1.9258000000000002 0.7060929616941001 0.7060914122785903 -1.514047655477857e-07 -0.09942647060945398 +1.9259000000000002 0.7060932680477009 0.7060917210289157 -1.5432595630582302e-07 -0.09942664433752185 +1.926 0.7060935742772638 0.7060920297172253 -1.5722066410740754e-07 -0.09942681801311692 +1.9261000000000001 0.7060938803831092 0.7060923383432549 -1.6008823079498302e-07 -0.09942699163625494 +1.9262000000000001 0.7060941863655641 0.7060926469067332 -1.6292800466069512e-07 -0.09942716520695168 +1.9263000000000001 0.7060944922249628 0.7060929554073823 -1.6573934056088313e-07 -0.09942733872522286 +1.9264000000000001 0.706094797961646 0.7060932638449169 -1.685216001190426e-07 -0.09942751219108421 +1.9265 0.7060951035759617 0.7060935722190458 -1.712741518073574e-07 -0.09942768560455158 +1.9266 0.7060954090682643 0.7060938805294703 -1.739963711531317e-07 -0.0994278589656406 +1.9267 0.7060957144389144 0.7060941887758854 -1.7668764083419997e-07 -0.09942803227436704 +1.9268000000000003 0.7060960196882795 0.7060944969579794 -1.7934735082117403e-07 -0.0994282055307466 +1.9269 0.7060963248167338 0.7060948050754343 -1.819748985630587e-07 -0.09942837873479499 +1.927 0.7060966298246578 0.7060951131279257 -1.8456968905317117e-07 -0.09942855188652795 +1.9271 0.7060969347124375 0.7060954211151231 -1.8713113501128698e-07 -0.09942872498596118 +1.9272 0.7060972394804663 0.7060957290366892 -1.896586570224179e-07 -0.0994288980331104 +1.9273000000000002 0.7060975441291426 0.7060960368922811 -1.9215168362007873e-07 -0.09942907102799131 +1.9274 0.7060978486588714 0.7060963446815498 -1.9460965148404563e-07 -0.09942924397061959 +1.9275 0.7060981530700636 0.7060966524041401 -1.9703200548198962e-07 -0.09942941686101092 +1.9276000000000002 0.7060984573631359 0.7060969600596911 -1.9941819888458223e-07 -0.09942958969918099 +1.9277 0.706098761538511 0.7060972676478364 -2.0176769342100664e-07 -0.09942976248514557 +1.9278000000000002 0.7060990655966165 0.7060975751682033 -2.0407995942814394e-07 -0.09942993521892018 +1.9279000000000002 0.7060993695378863 0.7060978826204138 -2.0635447598588152e-07 -0.09943010790052059 +1.928 0.7060996733627596 0.7060981900040849 -2.0859073099344094e-07 -0.09943028052996249 +1.9281000000000001 0.7060999770716812 0.7060984973188273 -2.1078822132203356e-07 -0.09943045310726151 +1.9282000000000001 0.7061002806651002 0.7060988045642473 -2.129464528981273e-07 -0.09943062563243327 +1.9283000000000001 0.7061005841434723 0.7060991117399456 -2.1506494084569394e-07 -0.09943079810549355 +1.9284000000000001 0.706100887507257 0.7060994188455174 -2.171432095660064e-07 -0.09943097052645783 +1.9285 0.7061011907569197 0.7060997258805535 -2.1918079285213055e-07 -0.09943114289534188 +1.9286 0.7061014938929301 0.7061000328446397 -2.2117723402770295e-07 -0.09943131521216131 +1.9287 0.7061017969157629 0.7061003397373569 -2.2313208598856438e-07 -0.09943148747693176 +1.9288000000000003 0.7061020998258976 0.7061006465582813 -2.2504491133806814e-07 -0.09943165968966884 +1.9289 0.7061024026238178 0.7061009533069844 -2.26915282494633e-07 -0.09943183185038816 +1.929 0.7061027053100122 0.7061012599830336 -2.287427817646015e-07 -0.09943200395910538 +1.9291 0.706103007884973 0.706101566585992 -2.3052700144979288e-07 -0.09943217601583614 +1.9292 0.706103310349198 0.7061018731154175 -2.3226754392036142e-07 -0.09943234802059601 +1.9293000000000002 0.7061036127031877 0.7061021795708649 -2.3396402171887987e-07 -0.09943251997340062 +1.9294 0.7061039149474473 0.7061024859518843 -2.356160576470756e-07 -0.09943269187426552 +1.9295 0.7061042170824858 0.7061027922580223 -2.3722328486297517e-07 -0.09943286372320637 +1.9296000000000002 0.7061045191088162 0.7061030984888219 -2.387853469051904e-07 -0.09943303552023877 +1.9297 0.7061048210269548 0.7061034046438213 -2.403018978629212e-07 -0.09943320726537824 +1.9298000000000002 0.706105122837422 0.7061037107225563 -2.4177260233779196e-07 -0.09943337895864045 +1.9299000000000002 0.7061054245407408 0.7061040167245589 -2.431971356554874e-07 -0.09943355060004093 +1.93 0.7061057261374384 0.7061043226493573 -2.44575183789425e-07 -0.09943372218959526 +1.9301000000000001 0.7061060276280451 0.7061046284964767 -2.459064435481051e-07 -0.09943389372731903 +1.9302000000000001 0.7061063290130938 0.7061049342654394 -2.4719062258551916e-07 -0.09943406521322777 +1.9303000000000001 0.7061066302931208 0.7061052399557644 -2.4842743947400825e-07 -0.09943423664733704 +1.9304000000000001 0.7061069314686654 0.7061055455669679 -2.4961662377018246e-07 -0.09943440802966247 +1.9305 0.7061072325402693 0.7061058510985636 -2.5075791608430986e-07 -0.09943457936021957 +1.9306 0.7061075335084772 0.7061061565500621 -2.51851068115011e-07 -0.09943475063902392 +1.9307 0.7061078343738356 0.7061064619209716 -2.528958426943617e-07 -0.09943492186609096 +1.9308 0.7061081351368945 0.7061067672107981 -2.5389201389197646e-07 -0.09943509304143633 +1.9309 0.706108435798205 0.706107072419045 -2.5483936698725285e-07 -0.09943526416507553 +1.931 0.7061087363583214 0.706107377545214 -2.5573769860468e-07 -0.09943543523702408 +1.9311 0.7061090368177994 0.706107682588804 -2.565868166583274e-07 -0.09943560625729755 +1.9312 0.7061093371771967 0.7061079875493127 -2.5738654051490895e-07 -0.0994357772259114 +1.9313000000000002 0.7061096374370729 0.7061082924262354 -2.5813670088276064e-07 -0.09943594814288115 +1.9314 0.7061099375979893 0.7061085972190664 -2.5883713997490454e-07 -0.09943611900822236 +1.9315 0.7061102376605088 0.7061089019272979 -2.5948771148129324e-07 -0.09943628982195052 +1.9316000000000002 0.7061105376251955 0.7061092065504206 -2.6008828060003486e-07 -0.0994364605840811 +1.9317 0.7061108374926148 0.7061095110879243 -2.606387240998431e-07 -0.09943663129462964 +1.9318000000000002 0.7061111372633335 0.7061098155392974 -2.6113893029922064e-07 -0.09943680195361158 +1.9319000000000002 0.7061114369379193 0.7061101199040273 -2.6158879910462285e-07 -0.09943697256104246 +1.932 0.7061117365169408 0.7061104241816003 -2.619882420624997e-07 -0.09943714311693776 +1.9321000000000002 0.7061120360009674 0.7061107283715022 -2.6233718232460124e-07 -0.09943731362131294 +1.9322000000000001 0.7061123353905694 0.7061110324732176 -2.626355547000192e-07 -0.09943748407418349 +1.9323000000000001 0.7061126346863172 0.7061113364862313 -2.6288330566212603e-07 -0.09943765447556485 +1.9324000000000001 0.7061129338887822 0.7061116404100265 -2.63080393334697e-07 -0.09943782482547252 +1.9325 0.7061132329985356 0.7061119442440874 -2.6322678750231865e-07 -0.09943799512392196 +1.9326 0.7061135320161488 0.7061122479878972 -2.63322469652022e-07 -0.09943816537092856 +1.9327 0.7061138309421937 0.7061125516409392 -2.6336743291777154e-07 -0.09943833556650787 +1.9328 0.7061141297772415 0.7061128552026967 -2.633616821394458e-07 -0.09943850571067524 +1.9329 0.7061144285218637 0.7061131586726535 -2.633052337969177e-07 -0.09943867580344616 +1.933 0.7061147271766313 0.7061134620502935 -2.6319811602393273e-07 -0.09943884584483609 +1.9331 0.7061150257421148 0.7061137653351008 -2.630403686428029e-07 -0.09943901583486042 +1.9332 0.7061153242188842 0.7061140685265607 -2.628320430950182e-07 -0.09943918577353464 +1.9333000000000002 0.7061156226075087 0.7061143716241586 -2.625732024343075e-07 -0.09943935566087413 +1.9334 0.7061159209085566 0.7061146746273805 -2.6226392134745535e-07 -0.09943952549689426 +1.9335 0.7061162191225956 0.7061149775357145 -2.619042860710352e-07 -0.09943969528161056 +1.9336000000000002 0.7061165172501922 0.7061152803486485 -2.6149439443651223e-07 -0.09943986501503838 +1.9337 0.7061168152919113 0.7061155830656719 -2.61034355790446e-07 -0.09944003469719306 +1.9338000000000002 0.7061171132483168 0.7061158856862761 -2.6052429099795993e-07 -0.09944020432809013 +1.9339000000000002 0.7061174111199713 0.706116188209953 -2.599643323802914e-07 -0.0994403739077449 +1.934 0.7061177089074357 0.7061164906361965 -2.5935462374254703e-07 -0.09944054343617278 +1.9341000000000002 0.706118006611269 0.7061167929645025 -2.5869532024186404e-07 -0.09944071291338917 +1.9342000000000001 0.7061183042320285 0.7061170951943682 -2.5798658846026834e-07 -0.09944088233940945 +1.9343000000000001 0.7061186017702699 0.7061173973252926 -2.5722860623814126e-07 -0.099441051714249 +1.9344000000000001 0.7061188992265464 0.7061176993567773 -2.5642156275401673e-07 -0.09944122103792319 +1.9345 0.7061191966014091 0.7061180012883252 -2.555656583788646e-07 -0.09944139031044737 +1.9346 0.7061194938954071 0.7061183031194428 -2.5466110468649883e-07 -0.09944155953183695 +1.9347 0.7061197911090866 0.7061186048496377 -2.5370812439112767e-07 -0.09944172870210725 +1.9348 0.7061200882429919 0.7061189064784206 -2.5270695127449505e-07 -0.09944189782127359 +1.9349 0.706120385297664 0.7061192080053049 -2.516578301477168e-07 -0.09944206688935138 +1.935 0.7061206822736414 0.7061195094298067 -2.5056101677148335e-07 -0.09944223590635598 +1.9351 0.7061209791714601 0.706119810751445 -2.4941677779707905e-07 -0.09944240487230271 +1.9352 0.7061212759916524 0.7061201119697412 -2.482253907143406e-07 -0.09944257378720685 +1.9353000000000002 0.7061215727347478 0.7061204130842208 -2.469871438239013e-07 -0.09944274265108381 +1.9354 0.706121869401273 0.7061207140944119 -2.4570233604290226e-07 -0.09944291146394893 +1.9355 0.7061221659917506 0.706121014999846 -2.4437127699172834e-07 -0.09944308022581749 +1.9356000000000002 0.7061224625067002 0.7061213158000579 -2.4299428679278035e-07 -0.09944324893670478 +1.9357 0.7061227589466377 0.7061216164945862 -2.4157169606700557e-07 -0.09944341759662619 +1.9358000000000002 0.7061230553120752 0.7061219170829733 -2.4010384582287547e-07 -0.09944358620559697 +1.9359000000000002 0.7061233516035215 0.7061222175647651 -2.3859108736618007e-07 -0.09944375476363249 +1.936 0.7061236478214805 0.7061225179395112 -2.3703378225839455e-07 -0.09944392327074791 +1.9361000000000002 0.7061239439664531 0.7061228182067659 -2.3543230220218758e-07 -0.09944409172695869 +1.9362000000000001 0.7061242400389357 0.7061231183660869 -2.3378702893733783e-07 -0.09944426013228001 +1.9363000000000001 0.7061245360394204 0.7061234184170364 -2.3209835416093672e-07 -0.0994444284867272 +1.9364000000000001 0.7061248319683953 0.7061237183591812 -2.303666794892245e-07 -0.09944459679031561 +1.9365 0.7061251278263436 0.7061240181920918 -2.285924162494235e-07 -0.09944476504306043 +1.9366 0.7061254236137441 0.7061243179153437 -2.2677598550055467e-07 -0.09944493324497694 +1.9367 0.706125719331071 0.7061246175285172 -2.2491781785302645e-07 -0.09944510139608043 +1.9368 0.706126014978794 0.7061249170311967 -2.2301835339577636e-07 -0.09944526949638616 +1.9369 0.7061263105573776 0.7061252164229722 -2.2107804160606537e-07 -0.09944543754590938 +1.937 0.7061266060672815 0.7061255157034381 -2.1909734119682223e-07 -0.09944560554466533 +1.9371 0.7061269015089605 0.706125814872194 -2.1707672005419343e-07 -0.09944577349266936 +1.9372 0.7061271968828637 0.7061261139288444 -2.15016655119582e-07 -0.09944594138993657 +1.9373000000000002 0.7061274921894358 0.7061264128729996 -2.1291763226821692e-07 -0.09944610923648231 +1.9374 0.7061277874291155 0.7061267117042744 -2.107801461842529e-07 -0.09944627703232178 +1.9375 0.7061280826023362 0.70612701042229 -2.0860470027056488e-07 -0.09944644477747018 +1.9376000000000002 0.7061283777095262 0.7061273090266722 -2.063918064995618e-07 -0.09944661247194284 +1.9377 0.7061286727511078 0.7061276075170525 -2.041419853021642e-07 -0.09944678011575485 +1.9378000000000002 0.7061289677274976 0.7061279058930685 -2.018557654880071e-07 -0.09944694770892148 +1.9379000000000002 0.7061292626391067 0.7061282041543634 -1.995336840511508e-07 -0.09944711525145798 +1.938 0.70612955748634 0.7061285023005862 -1.9717628607987536e-07 -0.09944728274337955 +1.9381000000000002 0.7061298522695968 0.706128800331392 -1.94784124666475e-07 -0.0994474501847014 +1.9382000000000001 0.70613014698927 0.7061290982464417 -1.9235776067827448e-07 -0.0994476175754387 +1.9383000000000001 0.7061304416457468 0.7061293960454023 -1.8989776274028203e-07 -0.0994477849156067 +1.9384000000000001 0.7061307362394075 0.706129693727947 -1.874047070131446e-07 -0.09944795220522051 +1.9385 0.7061310307706269 0.7061299912937555 -1.8487917710988122e-07 -0.09944811944429541 +1.9386 0.706131325239773 0.7061302887425136 -1.823217639362884e-07 -0.09944828663284651 +1.9387 0.7061316196472074 0.7061305860739135 -1.7973306555910118e-07 -0.099448453770889 +1.9388 0.7061319139932853 0.7061308832876545 -1.7711368707068464e-07 -0.09944862085843813 +1.9389 0.7061322082783554 0.706131180383441 -1.7446424043637832e-07 -0.09944878789550894 +1.939 0.7061325025027594 0.7061314773609857 -1.7178534436265713e-07 -0.09944895488211665 +1.9391 0.7061327966668327 0.7061317742200073 -1.6907762414621053e-07 -0.0994491218182765 +1.9392 0.7061330907709036 0.706132070960231 -1.6634171153516453e-07 -0.09944928870400353 +1.9393000000000002 0.7061333848152935 0.7061323675813894 -1.635782445746914e-07 -0.09944945553931295 +1.9394 0.7061336788003172 0.7061326640832217 -1.607878674595581e-07 -0.09944962232421993 +1.9395 0.7061339727262822 0.706132960465474 -1.5797123039534844e-07 -0.09944978905873955 +1.9396000000000002 0.7061342665934891 0.7061332567278997 -1.5512898942672548e-07 -0.09944995574288698 +1.9397 0.7061345604022313 0.706133552870259 -1.5226180628651054e-07 -0.09945012237667739 +1.9398000000000002 0.706134854152795 0.7061338488923197 -1.4937034826904838e-07 -0.09945028896012582 +1.9399000000000002 0.7061351478454594 0.7061341447938563 -1.4645528804632657e-07 -0.09945045549324748 +1.94 0.7061354414804961 0.7061344405746508 -1.4351730350664615e-07 -0.09945062197605746 +1.9401000000000002 0.7061357350581695 0.7061347362344925 -1.4055707764706882e-07 -0.09945078840857083 +1.9402000000000001 0.7061360285787368 0.7061350317731785 -1.3757529834790283e-07 -0.09945095479080278 +1.9403000000000001 0.7061363220424473 0.7061353271905128 -1.3457265825994602e-07 -0.09945112112276838 +1.9404000000000001 0.706136615449543 0.7061356224863067 -1.3154985462580926e-07 -0.09945128740448271 +1.9405 0.7061369088002585 0.7061359176603798 -1.2850758911511773e-07 -0.09945145363596092 +1.9406 0.7061372020948209 0.7061362127125586 -1.2544656767185525e-07 -0.09945161981721805 +1.9407 0.7061374953334493 0.7061365076426773 -1.2236750034609611e-07 -0.0994517859482692 +1.9408 0.7061377885163553 0.7061368024505785 -1.1927110111879802e-07 -0.09945195202912949 +1.9409 0.706138081643743 0.7061370971361113 -1.1615808777169778e-07 -0.09945211805981398 +1.941 0.7061383747158083 0.7061373916991333 -1.1302918166700149e-07 -0.09945228404033771 +1.9411 0.7061386677327399 0.7061376861395099 -1.0988510762074966e-07 -0.09945244997071581 +1.9412 0.7061389606947179 0.706137980457114 -1.0672659373281435e-07 -0.09945261585096331 +1.9413000000000002 0.7061392536019153 0.7061382746518262 -1.035543711908754e-07 -0.09945278168109523 +1.9414 0.7061395464544966 0.7061385687235359 -1.0036917413337731e-07 -0.09945294746112672 +1.9415 0.7061398392526191 0.7061388626721392 -9.717173946478114e-08 -0.0994531131910728 +1.9416000000000002 0.7061401319964313 0.7061391564975408 -9.3962806676888e-08 -0.09945327887094849 +1.9417 0.7061404246860745 0.7061394501996532 -9.07431176944487e-08 -0.09945344450076886 +1.9418000000000002 0.7061407173216816 0.7061397437783969 -8.75134166990893e-08 -0.09945361008054894 +1.9419000000000002 0.7061410099033774 0.7061400372337007 -8.427444994456301e-08 -0.09945377561030377 +1.942 0.7061413024312786 0.7061403305655007 -8.102696560235989e-08 -0.09945394109004838 +1.9421000000000002 0.7061415949054946 0.7061406237737419 -7.777171357782608e-08 -0.09945410651979777 +1.9422000000000001 0.7061418873261256 0.7061409168583763 -7.450944534016096e-08 -0.09945427189956697 +1.9423000000000001 0.7061421796932646 0.7061412098193653 -7.124091375154684e-08 -0.09945443722937103 +1.9424000000000001 0.7061424720069962 0.7061415026566775 -6.796687288760511e-08 -0.09945460250922498 +1.9425 0.7061427642673966 0.7061417953702895 -6.468807786782702e-08 -0.09945476773914373 +1.9426 0.7061430564745346 0.7061420879601864 -6.140528468123393e-08 -0.09945493291914237 +1.9427 0.7061433486284701 0.7061423804263615 -5.811925001377241e-08 -0.0994550980492359 +1.9428 0.7061436407292554 0.7061426727688156 -5.483073106985446e-08 -0.09945526312943925 +1.9429 0.7061439327769343 0.7061429649875586 -5.154048539671684e-08 -0.09945542815976749 +1.943 0.7061442247715426 0.7061432570826073 -4.824927071767071e-08 -0.09945559314023551 +1.9431 0.7061445167131082 0.7061435490539878 -4.4957844750280994e-08 -0.09945575807085838 +1.9432 0.7061448086016505 0.7061438409017335 -4.166696503498106e-08 -0.09945592295165108 +1.9433000000000002 0.7061451004371809 0.7061441326258864 -3.83773887615191e-08 -0.09945608778262854 +1.9434 0.7061453922197027 0.7061444242264963 -3.508987259353419e-08 -0.09945625256380569 +1.9435 0.7061456839492111 0.7061447157036214 -3.1805172494379225e-08 -0.09945641729519757 +1.9436000000000002 0.7061459756256931 0.7061450070573274 -2.852404355400094e-08 -0.09945658197681911 +1.9437 0.7061462672491278 0.706145298287689 -2.524723981441046e-08 -0.09945674660868525 +1.9438000000000002 0.706146558819486 0.7061455893947883 -2.1975514098541982e-08 -0.09945691119081097 +1.9439000000000002 0.7061468503367307 0.7061458803787152 -1.870961783504571e-08 -0.09945707572321119 +1.944 0.7061471418008163 0.7061461712395684 -1.5450300889802843e-08 -0.09945724020590085 +1.9441000000000002 0.7061474332116899 0.7061464619774543 -1.2198311385731159e-08 -0.09945740463889492 +1.9442000000000002 0.7061477245692902 0.7061467525924872 -8.954395540588383e-09 -0.09945756902220831 +1.9443000000000001 0.7061480158735478 0.7061470430847894 -5.719297491331432e-09 -0.09945773335585593 +1.9444000000000001 0.7061483071243856 0.706147333454491 -2.493759118475658e-09 -0.09945789763985274 +1.9445 0.7061485983217183 0.7061476237017306 7.214801126323445e-10 -0.09945806187421363 +1.9446 0.7061488894654526 0.7061479138266538 3.92568333135862e-09 -0.09945822605895349 +1.9447 0.7061491805554883 0.7061482038294149 7.118116420942733e-09 -0.09945839019408732 +1.9448 0.7061494715917158 0.7061484937101756 1.0298048198909004e-08 -0.09945855427962996 +1.9449 0.706149762574019 0.7061487834691056 1.3464750580997886e-08 -0.0994587183155963 +1.945 0.7061500535022733 0.706149073106382 1.66174987320869e-08 -0.09945888230200128 +1.9451 0.7061503443763466 0.70614936262219 1.9755571257010218e-08 -0.09945904623885977 +1.9452 0.706150635196099 0.7061496520167222 2.287825035061225e-08 -0.09945921012618664 +1.9453000000000003 0.7061509259613832 0.7061499412901794 2.598482195387275e-08 -0.0994593739639968 +1.9454 0.7061512166720438 0.7061502304427694 2.907457593952223e-08 -0.09945953775230515 +1.9455 0.7061515073279184 0.7061505194747075 3.2146806265564987e-08 -0.09945970149112651 +1.9456000000000002 0.7061517979288365 0.7061508083862172 3.520081111839379e-08 -0.09945986518047578 +1.9457 0.7061520884746206 0.7061510971775291 3.823589310447684e-08 -0.09946002882036784 +1.9458000000000002 0.7061523789650854 0.7061513858488807 4.1251359382196706e-08 -0.09946019241081752 +1.9459000000000002 0.7061526694000386 0.7061516744005178 4.424652183705746e-08 -0.09946035595183973 +1.946 0.7061529597792803 0.7061519628326929 4.722069722219724e-08 -0.09946051944344926 +1.9461000000000002 0.7061532501026031 0.7061522511456657 5.0173207344003656e-08 -0.09946068288566101 +1.9462000000000002 0.7061535403697927 0.7061525393397039 5.310337917834029e-08 -0.09946084627848979 +1.9463000000000001 0.7061538305806276 0.7061528274150812 5.601054505789682e-08 -0.09946100962195045 +1.9464000000000001 0.7061541207348796 0.706153115372079 5.889404279361965e-08 -0.09946117291605781 +1.9465 0.7061544108323123 0.7061534032109859 6.175321585685789e-08 -0.0994613361608267 +1.9466 0.7061547008726838 0.7061536909320972 6.458741349905928e-08 -0.099461499356272 +1.9467 0.7061549908557443 0.7061539785357152 6.739599092003834e-08 -0.09946166250240848 +1.9468 0.7061552807812369 0.7061542660221488 7.017830941369319e-08 -0.09946182559925096 +1.9469 0.7061555706488991 0.7061545533917142 7.29337365015792e-08 -0.09946198864681428 +1.947 0.7061558604584606 0.7061548406447336 7.566164607689108e-08 -0.09946215164511327 +1.9471 0.706156150209645 0.7061551277815361 7.836141856752687e-08 -0.09946231459416262 +1.9472 0.7061564399021691 0.7061554148024578 8.103244105231444e-08 -0.09946247749397731 +1.9473000000000003 0.7061567295357432 0.706155701707841 8.36741074067282e-08 -0.09946264034457197 +1.9474 0.7061570191100713 0.7061559884980337 8.628581845901429e-08 -0.09946280314596147 +1.9475 0.7061573086248512 0.7061562751733916 8.886698207519195e-08 -0.09946296589816059 +1.9476000000000002 0.7061575980797739 0.7061565617342755 9.141701337242458e-08 -0.09946312860118411 +1.9477 0.7061578874745247 0.7061568481810528 9.393533477800031e-08 -0.0994632912550468 +1.9478000000000002 0.7061581768087826 0.7061571345140971 9.642137620280433e-08 -0.09946345385976342 +1.9479000000000002 0.7061584660822207 0.706157420733788 9.887457515581066e-08 -0.09946361641534879 +1.948 0.7061587552945057 0.7061577068405105 1.0129437686204334e-07 -0.09946377892181756 +1.9481000000000002 0.7061590444452992 0.7061579928346565 1.0368023440829321e-07 -0.09946394137918464 +1.9482000000000002 0.7061593335342564 0.706158278716623 1.0603160885067076e-07 -0.09946410378746473 +1.9483000000000001 0.7061596225610272 0.7061585644868122 1.0834796934297564e-07 -0.09946426614667256 +1.9484000000000001 0.7061599115252553 0.7061588501456327 1.1062879326506625e-07 -0.09946442845682285 +1.9485 0.7061602004265795 0.7061591356934984 1.1287356632000423e-07 -0.09946459071793042 +1.9486 0.7061604892646332 0.7061594211308285 1.1508178266589342e-07 -0.09946475293000995 +1.9487 0.7061607780390438 0.7061597064580474 1.1725294502343275e-07 -0.09946491509307616 +1.9488 0.7061610667494345 0.706159991675585 1.193865647834691e-07 -0.09946507720714388 +1.9489 0.7061613553954222 0.7061602767838759 1.2148216214577512e-07 -0.09946523927222772 +1.949 0.7061616439766198 0.7061605617833603 1.2353926619537714e-07 -0.09946540128834247 +1.9491 0.7061619324926344 0.7061608466744829 1.2555741499276074e-07 -0.09946556325550278 +1.9492 0.7061622209430687 0.7061611314576934 1.2753615571264865e-07 -0.09946572517372347 +1.9493000000000003 0.7061625093275206 0.7061614161334462 1.2947504475502303e-07 -0.0994658870430191 +1.9494 0.7061627976455833 0.7061617007022005 1.31373647811045e-07 -0.09946604886340454 +1.9495 0.7061630858968457 0.7061619851644199 1.332315399601991e-07 -0.09946621063489437 +1.9496000000000002 0.7061633740808915 0.7061622695205722 1.3504830579519345e-07 -0.09946637235750332 +1.9497 0.7061636621973009 0.7061625537711297 1.3682353950869586e-07 -0.09946653403124607 +1.9498000000000002 0.7061639502456496 0.7061628379165692 1.3855684493149778e-07 -0.09946669565613733 +1.9499000000000002 0.7061642382255091 0.7061631219573713 1.402478357094561e-07 -0.09946685723219177 +1.95 0.7061645261364466 0.7061634058940208 1.4189613531390144e-07 -0.09946701875942407 +1.9501000000000002 0.7061648139780259 0.7061636897270065 1.4350137715612998e-07 -0.09946718023784895 +1.9502000000000002 0.7061651017498064 0.7061639734568204 1.4506320467760903e-07 -0.09946734166748095 +1.9503000000000001 0.7061653894513442 0.7061642570839588 1.4658127141242705e-07 -0.09946750304833482 +1.9504000000000001 0.7061656770821918 0.7061645406089214 1.48055241067091e-07 -0.0994676643804252 +1.9505 0.7061659646418981 0.7061648240322114 1.4948478758991524e-07 -0.09946782566376679 +1.9506000000000001 0.7061662521300087 0.7061651073543354 1.508695952751049e-07 -0.09946798689837419 +1.9507 0.706166539546066 0.7061653905758032 1.5220935878704211e-07 -0.09946814808426212 +1.9508 0.7061668268896089 0.7061656736971278 1.5350378326783876e-07 -0.09946830922144517 +1.9509 0.7061671141601731 0.706165956718825 1.5475258434080597e-07 -0.09946847030993793 +1.951 0.7061674013572923 0.7061662396414137 1.559554882561709e-07 -0.09946863134975509 +1.9511 0.7061676884804968 0.7061665224654157 1.5711223189454615e-07 -0.09946879234091127 +1.9512 0.7061679755293139 0.7061668051913552 1.582225628467271e-07 -0.09946895328342109 +1.9513000000000003 0.7061682625032688 0.7061670878197591 1.5928623944838627e-07 -0.0994691141772992 +1.9514 0.7061685494018843 0.7061673703511571 1.6030303083211517e-07 -0.09946927502256017 +1.9515 0.7061688362246803 0.7061676527860805 1.6127271703150758e-07 -0.09946943581921865 +1.9516000000000002 0.7061691229711751 0.7061679351250634 1.6219508896034296e-07 -0.09946959656728924 +1.9517 0.7061694096408841 0.7061682173686419 1.630699484889142e-07 -0.09946975726678653 +1.9518000000000002 0.7061696962333217 0.706168499517354 1.638971084648444e-07 -0.0994699179177251 +1.9519000000000002 0.7061699827479996 0.7061687815717395 1.6467639280329238e-07 -0.09947007852011958 +1.952 0.706170269184428 0.7061690635323399 1.654076364661361e-07 -0.09947023907398453 +1.9521000000000002 0.7061705555421159 0.7061693453996989 1.6609068552442263e-07 -0.09947039957933462 +1.9522 0.7061708418205699 0.7061696271743607 1.6672539718612378e-07 -0.09947056003618432 +1.9523000000000001 0.7061711280192959 0.7061699088568718 1.673116398585861e-07 -0.09947072044454826 +1.9524000000000001 0.7061714141377984 0.7061701904477795 1.6784929308261143e-07 -0.099470880804441 +1.9525 0.7061717001755804 0.7061704719476324 1.6833824765735694e-07 -0.09947104111587717 +1.9526000000000001 0.706171986132144 0.7061707533569799 1.687784056403352e-07 -0.09947120137887121 +1.9527 0.7061722720069907 0.7061710346763728 1.691696803196585e-07 -0.09947136159343777 +1.9528 0.7061725577996212 0.7061713159063623 1.6951199625220292e-07 -0.09947152175959141 +1.9529 0.7061728435095347 0.7061715970474999 1.6980528930524152e-07 -0.09947168187734662 +1.953 0.7061731291362308 0.7061718781003383 1.7004950665991392e-07 -0.09947184194671799 +1.9531 0.7061734146792082 0.7061721590654308 1.7024460675918451e-07 -0.09947200196772005 +1.9532 0.7061737001379654 0.7061724399433302 1.7039055941539538e-07 -0.09947216194036734 +1.9533000000000003 0.7061739855120007 0.70617272073459 1.7048734574434676e-07 -0.0994723218646744 +1.9534 0.7061742708008123 0.7061730014397634 1.7053495816182762e-07 -0.09947248174065575 +1.9535 0.7061745560038988 0.7061732820594042 1.7053340043565735e-07 -0.09947264156832597 +1.9536000000000002 0.706174841120758 0.706173562594065 1.7048268763364405e-07 -0.09947280134769947 +1.9537 0.7061751261508891 0.706173843044299 1.70382846127054e-07 -0.09947296107879083 +1.9538000000000002 0.7061754110937911 0.7061741234106589 1.702339135836728e-07 -0.09947312076161463 +1.9539000000000002 0.7061756959489638 0.7061744036936961 1.7003593899209135e-07 -0.0994732803961853 +1.954 0.7061759807159074 0.7061746838939621 1.6978898259578656e-07 -0.09947343998251733 +1.9541000000000002 0.7061762653941231 0.7061749640120071 1.6949311586536564e-07 -0.09947359952062525 +1.9542 0.7061765499831129 0.7061752440483808 1.6914842153673004e-07 -0.09947375901052355 +1.9543000000000001 0.7061768344823799 0.7061755240036316 1.687549935520949e-07 -0.09947391845222674 +1.9544000000000001 0.7061771188914283 0.7061758038783067 1.6831293703917227e-07 -0.09947407784574928 +1.9545 0.7061774032097632 0.7061760836729525 1.6782236830076291e-07 -0.09947423719110567 +1.9546000000000001 0.7061776874368917 0.7061763633881131 1.6728341475577557e-07 -0.09947439648831036 +1.9547 0.706177971572322 0.7061766430243319 1.666962149149409e-07 -0.09947455573737779 +1.9548 0.7061782556155642 0.7061769225821506 1.6606091836346426e-07 -0.09947471493832255 +1.9549 0.70617853956613 0.7061772020621087 1.6537768571592282e-07 -0.09947487409115902 +1.955 0.7061788234235324 0.7061774814647441 1.6464668855728504e-07 -0.09947503319590166 +1.9551 0.7061791071872875 0.706177760790593 1.638681094325023e-07 -0.09947519225256496 +1.9552 0.7061793908569125 0.706178040040189 1.6304214177018106e-07 -0.09947535126116337 +1.9553000000000003 0.7061796744319273 0.7061783192140638 1.621689898617662e-07 -0.09947551022171132 +1.9554 0.7061799579118537 0.7061785983127464 1.6124886877480482e-07 -0.09947566913422323 +1.9555 0.7061802412962166 0.7061788773367639 1.6028200434947681e-07 -0.09947582799871357 +1.9556000000000002 0.7061805245845427 0.7061791562866404 1.5926863308757255e-07 -0.09947598681519679 +1.9557 0.7061808077763618 0.7061794351628977 1.582090021524929e-07 -0.0994761455836873 +1.9558000000000002 0.7061810908712065 0.7061797139660544 1.5710336925475743e-07 -0.09947630430419953 +1.9559000000000002 0.7061813738686122 0.7061799926966263 1.559520026311878e-07 -0.09947646297674789 +1.956 0.7061816567681173 0.7061802713551264 1.5475518098939656e-07 -0.09947662160134685 +1.9561000000000002 0.706181939569263 0.7061805499420643 1.535131933724787e-07 -0.09947678017801069 +1.9562 0.7061822222715941 0.7061808284579467 1.5222633914513395e-07 -0.09947693870675395 +1.9563000000000001 0.7061825048746591 0.7061811069032767 1.5089492792427772e-07 -0.09947709718759101 +1.9564000000000001 0.7061827873780087 0.7061813852785539 1.4951927946454946e-07 -0.09947725562053622 +1.9565 0.7061830697811984 0.7061816635842746 1.4809972363402646e-07 -0.099477414005604 +1.9566000000000001 0.706183352083787 0.7061819418209312 1.4663660028585435e-07 -0.0994775723428088 +1.9567 0.7061836342853365 0.7061822199890124 1.451302592166137e-07 -0.09947773063216492 +1.9568 0.7061839163854137 0.7061824980890029 1.4358106007264504e-07 -0.0994778888736868 +1.9569 0.7061841983835884 0.7061827761213839 1.4198937222167918e-07 -0.0994780470673888 +1.957 0.7061844802794354 0.7061830540866316 1.403555747285512e-07 -0.0994782052132853 +1.9571 0.706184762072533 0.7061833319852191 1.3868005623030033e-07 -0.09947836331139069 +1.9572 0.7061850437624638 0.7061836098176142 1.369632148529032e-07 -0.09947852136171925 +1.9573000000000003 0.7061853253488153 0.7061838875842812 1.3520545811065987e-07 -0.09947867936428548 +1.9574 0.7061856068311794 0.7061841652856791 1.3340720280557994e-07 -0.09947883731910367 +1.9575 0.7061858882091516 0.7061844429222628 1.3156887494064629e-07 -0.09947899522618814 +1.9576000000000002 0.7061861694823331 0.7061847204944824 1.2969090964695673e-07 -0.09947915308555325 +1.9577 0.7061864506503301 0.7061849980027833 1.2777375100331279e-07 -0.09947931089721342 +1.9578000000000002 0.7061867317127526 0.7061852754476059 1.2581785199458628e-07 -0.0994794686611829 +1.9579000000000002 0.7061870126692162 0.7061855528293854 1.2382367439028874e-07 -0.09947962637747607 +1.958 0.7061872935193416 0.7061858301485521 1.2179168863354906e-07 -0.0994797840461072 +1.9581000000000002 0.7061875742627546 0.7061861074055316 1.1972237371968286e-07 -0.09947994166709073 +1.9582 0.7061878548990859 0.7061863846007437 1.1761621710598691e-07 -0.09948009924044093 +1.9583000000000002 0.706188135427972 0.7061866617346029 1.1547371457643063e-07 -0.09948025676617206 +1.9584000000000001 0.7061884158490543 0.7061869388075184 1.132953701271644e-07 -0.09948041424429852 +1.9585 0.7061886961619803 0.7061872158198941 1.1108169584855832e-07 -0.09948057167483458 +1.9586000000000001 0.7061889763664027 0.7061874927721279 1.0883321183152717e-07 -0.09948072905779459 +1.9587 0.7061892564619798 0.7061877696646122 1.0655044601140529e-07 -0.0994808863931928 +1.9588 0.7061895364483761 0.7061880464977337 1.0423393406039372e-07 -0.09948104368104357 +1.9589 0.7061898163252613 0.7061883232718732 1.0188421925919067e-07 -0.09948120092136112 +1.959 0.7061900960923115 0.7061885999874052 9.950185235821363e-08 -0.09948135811415976 +1.9591 0.7061903757492085 0.7061888766446989 9.708739146310763e-08 -0.09948151525945378 +1.9592 0.7061906552956405 0.7061891532441169 9.464140189943682e-08 -0.09948167235725751 +1.9593000000000003 0.7061909347313016 0.7061894297860158 9.21644560843149e-08 -0.09948182940758513 +1.9594 0.7061912140558919 0.7061897062707461 8.965713339456616e-08 -0.09948198641045096 +1.9595 0.7061914932691183 0.7061899826986516 8.712002001753927e-08 -0.0994821433658693 +1.9596000000000002 0.7061917723706939 0.7061902590700704 8.455370881059465e-08 -0.0994823002738544 +1.9597 0.7061920513603379 0.7061905353853332 8.195879919875582e-08 -0.09948245713442047 +1.9598000000000002 0.7061923302377766 0.7061908116447648 7.933589699950228e-08 -0.09948261394758184 +1.9599000000000002 0.7061926090027426 0.7061910878486839 7.668561428225695e-08 -0.09948277071335278 +1.96 0.7061928876549746 0.7061913639974011 7.400856925562915e-08 -0.09948292743174743 +1.9601000000000002 0.7061931661942189 0.7061916400912216 7.130538609394221e-08 -0.09948308410278009 +1.9602 0.7061934446202277 0.7061919161304434 6.857669479845563e-08 -0.09948324072646497 +1.9603000000000002 0.7061937229327607 0.7061921921153578 6.582313105164828e-08 -0.09948339730281637 +1.9604000000000001 0.7061940011315844 0.7061924680462486 6.304533608364471e-08 -0.0994835538318485 +1.9605 0.7061942792164716 0.7061927439233934 6.024395650047754e-08 -0.0994837103135755 +1.9606000000000001 0.7061945571872029 0.7061930197470623 5.7419644140105364e-08 -0.09948386674801168 +1.9607 0.7061948350435656 0.7061932955175187 5.457305593536965e-08 -0.09948402313517125 +1.9608 0.7061951127853541 0.7061935712350188 5.170485373878764e-08 -0.09948417947506843 +1.9609 0.7061953904123699 0.7061938468998112 4.881570419071335e-08 -0.0994843357677174 +1.961 0.7061956679244217 0.7061941225121378 4.590627854239582e-08 -0.09948449201313232 +1.9611 0.706195945321326 0.706194398072233 4.2977252524140086e-08 -0.09948464821132752 +1.9612 0.7061962226029054 0.7061946735803242 4.002930616489597e-08 -0.0994848043623171 +1.9613000000000003 0.7061964997689909 0.7061949490366306 3.706312365694964e-08 -0.09948496046611525 +1.9614 0.7061967768194205 0.7061952244413651 3.407939317377762e-08 -0.09948511652273619 +1.9615 0.7061970537540398 0.7061954997947324 3.10788067277995e-08 -0.09948527253219411 +1.9616000000000002 0.7061973305727016 0.7061957750969303 2.8062060007313927e-08 -0.09948542849450319 +1.9617 0.7061976072752663 0.7061960503481483 2.5029852203026226e-08 -0.09948558440967756 +1.9618000000000002 0.706197883861602 0.7061963255485689 2.1982885871005275e-08 -0.09948574027773142 +1.9619000000000002 0.7061981603315839 0.7061966006983673 1.892186673492502e-08 -0.09948589609867897 +1.962 0.7061984366850955 0.7061968757977103 1.5847503564633825e-08 -0.09948605187253429 +1.9621000000000002 0.7061987129220272 0.7061971508467575 1.276050797492656e-08 -0.0994862075993116 +1.9622 0.7061989890422777 0.7061974258456611 9.661594277225738e-09 -0.09948636327902506 +1.9623000000000002 0.7061992650457534 0.706197700794565 6.551479311313335e-09 -0.09948651891168885 +1.9624000000000001 0.7061995409323676 0.7061979756936059 3.4308822918077686e-09 -0.09948667449731703 +1.9625 0.706199816702042 0.7061982505429119 3.0052462254848145e-10 -0.09948683003592378 +1.9626000000000001 0.706200092354706 0.7061985253426046 -2.8388702621312545e-09 -0.09948698552752328 +1.9627000000000001 0.7062003678902964 0.7061988000927969 -5.986577063070431e-09 -0.09948714097212957 +1.9628 0.7062006433087584 0.7061990747935939 -9.141868781946394e-09 -0.09948729636975684 +1.9629 0.7062009186100446 0.7061993494450932 -1.2304016892145109e-08 -0.09948745172041919 +1.963 0.7062011937941157 0.7061996240473849 -1.547229150919774e-08 -0.09948760702413077 +1.9631 0.7062014688609399 0.70619989860055 -1.864596155297729e-08 -0.0994877622809057 +1.9632 0.7062017438104934 0.7062001731046631 -2.1824294919002563e-08 -0.09948791749075805 +1.9633000000000003 0.7062020186427603 0.7062004475597898 -2.5006558652777844e-08 -0.09948807265370195 +1.9634 0.7062022933577327 0.7062007219659887 -2.819201911285693e-08 -0.09948822776975152 +1.9635 0.70620256795541 0.7062009963233098 -3.1379942136726055e-08 -0.09948838283892085 +1.9636000000000002 0.7062028424358004 0.7062012706317956 -3.4569593217312e-08 -0.09948853786122402 +1.9637 0.7062031167989191 0.7062015448914807 -3.7760237670382904e-08 -0.0994886928366751 +1.9638000000000002 0.7062033910447896 0.7062018191023918 -4.095114080146121e-08 -0.09948884776528827 +1.9639000000000002 0.7062036651734434 0.7062020932645475 -4.4141568075148916e-08 -0.09948900264707755 +1.964 0.7062039391849193 0.7062023673779585 -4.733078528494075e-08 -0.099489157482057 +1.9641000000000002 0.7062042130792646 0.7062026414426279 -5.0518058722142864e-08 -0.0994893122702407 +1.9642 0.7062044868565341 0.7062029154585511 -5.370265534652627e-08 -0.09948946701164274 +1.9643000000000002 0.7062047605167907 0.706203189425715 -5.688384295001424e-08 -0.0994896217062772 +1.9644000000000001 0.7062050340601049 0.706203463344099 -6.00608903297481e-08 -0.09948977635415812 +1.9645 0.7062053074865551 0.7062037372136749 -6.323306745359067e-08 -0.09948993095529957 +1.9646000000000001 0.7062055807962277 0.7062040110344063 -6.639964562774395e-08 -0.09949008550971562 +1.9647000000000001 0.7062058539892163 0.706204284806249 -6.955989766610146e-08 -0.09949024001742028 +1.9648 0.706206127065623 0.706204558529151 -7.271309805613121e-08 -0.09949039447842757 +1.9649 0.706206400025557 0.706204832203053 -7.58585231241081e-08 -0.09949054889275158 +1.965 0.7062066728691361 0.7062051058278875 -7.899545120034629e-08 -0.09949070326040638 +1.9651 0.7062069455964848 0.7062053794035794 -8.212316279006954e-08 -0.09949085758140595 +1.9652 0.7062072182077359 0.7062056529300459 -8.524094073387306e-08 -0.0994910118557643 +1.9653000000000003 0.7062074907030299 0.7062059264071963 -8.83480703699202e-08 -0.09949116608349545 +1.9654 0.7062077630825145 0.7062061998349327 -9.144383970611375e-08 -0.09949132026461352 +1.9655 0.7062080353463456 0.7062064732131497 -9.452753957014948e-08 -0.09949147439913246 +1.9656000000000002 0.7062083074946859 0.7062067465417333 -9.759846378645798e-08 -0.09949162848706627 +1.9657 0.7062085795277062 0.7062070198205629 -1.0065590933319712e-07 -0.09949178252842894 +1.9658000000000002 0.7062088514455849 0.7062072930495102 -1.0369917649057092e-07 -0.09949193652323456 +1.9659 0.706209123248507 0.7062075662284395 -1.0672756901950603e-07 -0.09949209047149704 +1.966 0.706209394936666 0.7062078393572073 -1.0974039431344007e-07 -0.09949224437323043 +1.9661000000000002 0.706209666510262 0.706208112435663 -1.1273696355271201e-07 -0.09949239822844864 +1.9662 0.7062099379695027 0.7062083854636487 -1.1571659185721783e-07 -0.09949255203716575 +1.9663000000000002 0.7062102093146034 0.706208658440999 -1.186785984728933e-07 -0.09949270579939572 +1.9664000000000001 0.7062104805457861 0.706208931367541 -1.2162230688186892e-07 -0.09949285951515248 +1.9665 0.7062107516632804 0.7062092042430954 -1.2454704499502423e-07 -0.09949301318445004 +1.9666000000000001 0.7062110226673228 0.7062094770674749 -1.2745214527688786e-07 -0.0994931668073024 +1.9667000000000001 0.7062112935581573 0.7062097498404858 -1.3033694493125303e-07 -0.0994933203837235 +1.9668 0.706211564336034 0.7062100225619268 -1.3320078601740393e-07 -0.09949347391372729 +1.9669 0.706211835001211 0.7062102952315894 -1.360430156218534e-07 -0.09949362739732766 +1.967 0.7062121055539531 0.706210567849259 -1.3886298599018188e-07 -0.09949378083453869 +1.9671 0.7062123759945317 0.7062108404147134 -1.4166005469877507e-07 -0.09949393422537428 +1.9672 0.7062126463232252 0.7062111129277239 -1.4443358478145873e-07 -0.09949408756984837 +1.9673000000000003 0.7062129165403188 0.7062113853880547 -1.4718294488215433e-07 -0.09949424086797491 +1.9674 0.7062131866461042 0.7062116577954638 -1.4990750938845276e-07 -0.09949439411976783 +1.9675 0.7062134566408799 0.7062119301497023 -1.5260665859814782e-07 -0.09949454732524106 +1.9676000000000002 0.7062137265249508 0.7062122024505144 -1.552797788337279e-07 -0.09949470048440856 +1.9677 0.7062139962986287 0.7062124746976381 -1.579262625846234e-07 -0.09949485359728419 +1.9678000000000002 0.706214265962231 0.7062127468908053 -1.6054550867027062e-07 -0.09949500666388193 +1.9679 0.7062145355160827 0.7062130190297407 -1.6313692234766475e-07 -0.09949515968421568 +1.968 0.7062148049605141 0.7062132911141632 -1.6569991546575014e-07 -0.09949531265829936 +1.9681000000000002 0.7062150742958619 0.7062135631437857 -1.68233906586851e-07 -0.09949546558614684 +1.9682 0.7062153435224692 0.7062138351183141 -1.7073832112197984e-07 -0.09949561846777204 +1.9683000000000002 0.7062156126406851 0.7062141070374494 -1.7321259145920698e-07 -0.09949577130318893 +1.9684000000000001 0.7062158816508644 0.7062143789008855 -1.7565615709896898e-07 -0.09949592409241129 +1.9685 0.7062161505533682 0.7062146507083108 -1.7806846477549931e-07 -0.09949607683545306 +1.9686000000000001 0.7062164193485632 0.706214922459408 -1.804489685938715e-07 -0.09949622953232812 +1.9687000000000001 0.7062166880368224 0.7062151941538538 -1.8279713011673526e-07 -0.0994963821830504 +1.9688 0.7062169566185235 0.7062154657913196 -1.8511241853258475e-07 -0.09949653478763375 +1.9689 0.7062172250940506 0.7062157373714704 -1.8739431075984192e-07 -0.09949668734609204 +1.969 0.7062174934637926 0.7062160088939662 -1.8964229155093992e-07 -0.09949683985843907 +1.9691 0.7062177617281449 0.7062162803584617 -1.918558536137538e-07 -0.0994969923246888 +1.9692 0.7062180298875071 0.7062165517646064 -1.940344977295616e-07 -0.0994971447448551 +1.9693000000000003 0.7062182979422852 0.7062168231120436 -1.961777328848835e-07 -0.09949729711895182 +1.9694 0.7062185658928888 0.7062170944004122 -1.9828507634434e-07 -0.09949744944699274 +1.9695 0.706218833739734 0.706217365629346 -2.0035605378596055e-07 -0.09949760172899175 +1.9696000000000002 0.7062191014832413 0.7062176367984737 -2.0239019939138903e-07 -0.09949775396496274 +1.9697 0.7062193691238361 0.7062179079074191 -2.0438705597425333e-07 -0.09949790615491956 +1.9698000000000002 0.7062196366619484 0.706218178955801 -2.0634617506690156e-07 -0.09949805829887598 +1.9699 0.7062199040980135 0.7062184499432336 -2.0826711700366873e-07 -0.09949821039684585 +1.97 0.7062201714324705 0.7062187208693265 -2.1014945106659355e-07 -0.099498362448843 +1.9701000000000002 0.7062204386657638 0.7062189917336847 -2.1199275552358232e-07 -0.09949851445488124 +1.9702 0.7062207057983416 0.7062192625359094 -2.1379661777412573e-07 -0.09949866641497444 +1.9703000000000002 0.7062209728306565 0.7062195332755963 -2.1556063440827944e-07 -0.09949881832913637 +1.9704000000000002 0.7062212397631658 0.706219803952338 -2.1728441132809473e-07 -0.09949897019738088 +1.9705 0.7062215065963304 0.7062200745657224 -2.1896756378925186e-07 -0.09949912201972178 +1.9706000000000001 0.7062217733306155 0.7062203451153337 -2.2060971652596018e-07 -0.09949927379617288 +1.9707000000000001 0.7062220399664896 0.7062206156007516 -2.2221050381687757e-07 -0.0994994255267479 +1.9708 0.7062223065044257 0.7062208860215526 -2.2376956958225502e-07 -0.09949957721146073 +1.9709 0.7062225729449003 0.7062211563773095 -2.252865674290394e-07 -0.09949972885032514 +1.971 0.7062228392883935 0.7062214266675909 -2.267611607931208e-07 -0.09949988044335491 +1.9711 0.7062231055353887 0.7062216968919622 -2.2819302294280197e-07 -0.0995000319905638 +1.9712 0.7062233716863726 0.7062219670499859 -2.2958183707594282e-07 -0.09950018349196564 +1.9713000000000003 0.7062236377418356 0.7062222371412202 -2.3092729640322718e-07 -0.09950033494757413 +1.9714 0.706223903702271 0.7062225071652215 -2.3222910419673504e-07 -0.0995004863574031 +1.9715 0.706224169568175 0.7062227771215417 -2.3348697390096484e-07 -0.09950063772146633 +1.9716000000000002 0.706224435340047 0.7062230470097306 -2.3470062912242518e-07 -0.09950078903977753 +1.9717 0.7062247010183894 0.7062233168293348 -2.3586980373718758e-07 -0.09950094031235052 +1.9718000000000002 0.7062249666037068 0.7062235865798989 -2.369942419221116e-07 -0.09950109153919906 +1.9719 0.7062252320965067 0.706223856260964 -2.3807369827627545e-07 -0.09950124272033686 +1.972 0.7062254974972992 0.7062241258720685 -2.3910793779322037e-07 -0.09950139385577766 +1.9721000000000002 0.7062257628065964 0.7062243954127492 -2.4009673594421743e-07 -0.0995015449455352 +1.9722 0.7062260280249133 0.7062246648825404 -2.4103987873377863e-07 -0.09950169598962327 +1.9723000000000002 0.7062262931527661 0.7062249342809741 -2.419371627482292e-07 -0.09950184698805555 +1.9724000000000002 0.7062265581906741 0.7062252036075801 -2.4278839517305473e-07 -0.0995019979408458 +1.9725 0.706226823139158 0.7062254728618866 -2.435933938622903e-07 -0.09950214884800773 +1.9726000000000001 0.7062270879987402 0.7062257420434197 -2.443519873697453e-07 -0.09950229970955508 +1.9727000000000001 0.7062273527699454 0.7062260111517039 -2.45064014952473e-07 -0.0995024505255016 +1.9728 0.7062276174532991 0.706226280186262 -2.457293267026095e-07 -0.09950260129586094 +1.9729 0.7062278820493284 0.7062265491466155 -2.463477834398209e-07 -0.09950275202064683 +1.973 0.7062281465585623 0.7062268180322842 -2.469192568500811e-07 -0.09950290269987297 +1.9731 0.7062284109815308 0.7062270868427871 -2.4744362946832466e-07 -0.09950305333355308 +1.9732 0.706228675318765 0.7062273555776417 -2.4792079469232453e-07 -0.0995032039217009 +1.9733000000000003 0.7062289395707966 0.7062276242363649 -2.483506568277949e-07 -0.09950335446433006 +1.9734 0.7062292037381587 0.7062278928184722 -2.487331311022689e-07 -0.09950350496145431 +1.9735 0.706229467821385 0.7062281613234784 -2.4906814366509877e-07 -0.09950365541308726 +1.9736000000000002 0.7062297318210096 0.7062284297508978 -2.4935563162215013e-07 -0.09950380581924258 +1.9737 0.7062299957375678 0.7062286981002444 -2.4959554303233267e-07 -0.09950395617993403 +1.9738000000000002 0.7062302595715946 0.706228966371031 -2.4978783691800843e-07 -0.09950410649517523 +1.9739 0.7062305233236259 0.706229234562771 -2.4993248328927797e-07 -0.0995042567649799 +1.974 0.7062307869941972 0.7062295026749772 -2.50029463133572e-07 -0.09950440698936168 +1.9741000000000002 0.7062310505838443 0.7062297707071623 -2.500787683913652e-07 -0.09950455716833423 +1.9742 0.7062313140931032 0.7062300386588389 -2.5008040200127923e-07 -0.09950470730191122 +1.9743000000000002 0.7062315775225093 0.7062303065295199 -2.5003437788620464e-07 -0.09950485739010625 +1.9744000000000002 0.7062318408725978 0.7062305743187185 -2.4994072091166775e-07 -0.09950500743293297 +1.9745 0.7062321041439037 0.7062308420259484 -2.497994669101167e-07 -0.0995051574304051 +1.9746000000000001 0.7062323673369615 0.7062311096507238 -2.49610662639288e-07 -0.09950530738253625 +1.9747000000000001 0.7062326304523048 0.7062313771925594 -2.4937436583424843e-07 -0.09950545728934007 +1.9748 0.7062328934904667 0.7062316446509703 -2.490906450963726e-07 -0.09950560715083016 +1.9749 0.7062331564519791 0.7062319120254732 -2.487595799696707e-07 -0.09950575696702016 +1.975 0.7062334193373733 0.7062321793155855 -2.4838126084017476e-07 -0.09950590673792371 +1.9751 0.7062336821471793 0.7062324465208253 -2.4795578892553016e-07 -0.09950605646355444 +1.9752 0.7062339448819255 0.7062327136407125 -2.4748327632703737e-07 -0.09950620614392595 +1.9753000000000003 0.7062342075421395 0.7062329806747676 -2.469638459012824e-07 -0.09950635577905181 +1.9754 0.7062344701283474 0.7062332476225135 -2.4639763127054515e-07 -0.09950650536894567 +1.9755 0.7062347326410736 0.7062335144834739 -2.4578477678810495e-07 -0.09950665491362118 +1.9756000000000002 0.7062349950808406 0.7062337812571746 -2.451254375174239e-07 -0.09950680441309188 +1.9757 0.7062352574481693 0.706234047943143 -2.4441977915928836e-07 -0.09950695386737138 +1.9758000000000002 0.7062355197435788 0.7062343145409083 -2.436679780171147e-07 -0.09950710327647327 +1.9759 0.7062357819675857 0.7062345810500019 -2.4287022100735745e-07 -0.09950725264041112 +1.976 0.7062360441207055 0.7062348474699571 -2.420267054999148e-07 -0.09950740195919858 +1.9761000000000002 0.7062363062034501 0.7062351138003099 -2.411376394083342e-07 -0.09950755123284916 +1.9762 0.7062365682163299 0.7062353800405982 -2.402032410336874e-07 -0.09950770046137646 +1.9763000000000002 0.7062368301598527 0.7062356461903623 -2.3922373905416183e-07 -0.09950784964479403 +1.9764000000000002 0.7062370920345235 0.7062359122491457 -2.381993724556719e-07 -0.0995079987831155 +1.9765 0.7062373538408447 0.7062361782164939 -2.3713039049022555e-07 -0.0995081478763544 +1.9766000000000001 0.7062376155793161 0.7062364440919555 -2.3601705259612693e-07 -0.09950829692452427 +1.9767000000000001 0.7062378772504341 0.7062367098750821 -2.3485962837369034e-07 -0.09950844592763869 +1.9768000000000001 0.7062381388546926 0.7062369755654281 -2.3365839744299288e-07 -0.0995085948857112 +1.9769 0.7062384003925821 0.706237241162551 -2.3241364946469112e-07 -0.09950874379875538 +1.977 0.70623866186459 0.706237506666012 -2.3112568400124323e-07 -0.09950889266678475 +1.9771 0.7062389232712001 0.7062377720753749 -2.297948104960923e-07 -0.09950904148981288 +1.9772 0.7062391846128928 0.7062380373902072 -2.2842134816958293e-07 -0.09950919026785324 +1.9773000000000003 0.7062394458901453 0.7062383026100802 -2.270056259565112e-07 -0.09950933900091938 +1.9774 0.7062397071034308 0.7062385677345686 -2.2554798240551066e-07 -0.09950948768902486 +1.9775 0.7062399682532192 0.706238832763251 -2.240487656270107e-07 -0.09950963633218324 +1.9776000000000002 0.7062402293399758 0.7062390976957098 -2.2250833318915308e-07 -0.09950978493040802 +1.9777 0.7062404903641624 0.7062393625315311 -2.209270520622808e-07 -0.09950993348371266 +1.9778000000000002 0.7062407513262363 0.7062396272703053 -2.1930529850444636e-07 -0.09951008199211066 +1.9779 0.7062410122266516 0.7062398919116266 -2.1764345794345052e-07 -0.09951023045561555 +1.978 0.7062412730658575 0.7062401564550942 -2.1594192494561737e-07 -0.09951037887424091 +1.9781000000000002 0.7062415338442987 0.7062404209003111 -2.1420110310477192e-07 -0.09951052724800019 +1.9782 0.7062417945624155 0.7062406852468845 -2.124214049346873e-07 -0.09951067557690683 +1.9783000000000002 0.7062420552206442 0.7062409494944265 -2.106032517580625e-07 -0.09951082386097437 +1.9784000000000002 0.7062423158194158 0.7062412136425538 -2.0874707365101108e-07 -0.09951097210021626 +1.9785 0.7062425763591569 0.706241477690888 -2.0685330928693624e-07 -0.09951112029464611 +1.9786000000000001 0.7062428368402895 0.7062417416390548 -2.049224058810195e-07 -0.09951126844427728 +1.9787000000000001 0.7062430972632299 0.7062420054866856 -2.0295481904797352e-07 -0.09951141654912325 +1.9788000000000001 0.7062433576283903 0.7062422692334162 -2.009510127222447e-07 -0.0995115646091975 +1.9789 0.7062436179361773 0.7062425328788879 -1.9891145904005203e-07 -0.09951171262451353 +1.979 0.7062438781869929 0.7062427964227471 -1.968366382110176e-07 -0.09951186059508484 +1.9791 0.7062441383812327 0.7062430598646451 -1.947270384279609e-07 -0.09951200852092482 +1.9792 0.706244398519288 0.7062433232042387 -1.9258315575240714e-07 -0.09951215640204693 +1.9793000000000003 0.7062446586015445 0.7062435864411902 -1.9040549397927875e-07 -0.09951230423846463 +1.9794 0.7062449186283819 0.7062438495751674 -1.8819456453281203e-07 -0.09951245203019138 +1.9795 0.7062451786001753 0.7062441126058437 -1.8595088633818757e-07 -0.09951259977724071 +1.9796 0.7062454385172927 0.7062443755328979 -1.8367498570703855e-07 -0.09951274747962591 +1.9797 0.7062456983800973 0.7062446383560147 -1.813673962194895e-07 -0.09951289513736043 +1.9798000000000002 0.7062459581889466 0.7062449010748847 -1.7902865857150063e-07 -0.0995130427504578 +1.9799 0.7062462179441917 0.7062451636892042 -1.766593204881317e-07 -0.09951319031893135 +1.98 0.7062464776461782 0.7062454261986757 -1.74259936560478e-07 -0.0995133378427946 +1.9801000000000002 0.7062467372952452 0.7062456886030074 -1.7183106813811744e-07 -0.09951348532206092 +1.9802 0.7062469968917258 0.7062459509019137 -1.6937328319206746e-07 -0.09951363275674367 +1.9803000000000002 0.7062472564359473 0.7062462130951155 -1.668871561812113e-07 -0.09951378014685636 +1.9804000000000002 0.7062475159282302 0.7062464751823394 -1.6437326790484652e-07 -0.09951392749241232 +1.9805 0.7062477753688892 0.7062467371633186 -1.6183220538992793e-07 -0.09951407479342497 +1.9806000000000001 0.7062480347582318 0.7062469990377929 -1.5926456174361614e-07 -0.09951422204990773 +1.9807000000000001 0.7062482940965604 0.7062472608055081 -1.5667093600582604e-07 -0.09951436926187401 +1.9808000000000001 0.7062485533841696 0.7062475224662167 -1.5405193303126563e-07 -0.09951451642933716 +1.9809 0.706248812621348 0.7062477840196777 -1.5140816333157614e-07 -0.09951466355231059 +1.981 0.7062490718083777 0.7062480454656566 -1.4874024292614585e-07 -0.09951481063080768 +1.9811 0.7062493309455341 0.7062483068039258 -1.460487932258836e-07 -0.09951495766484182 +1.9812 0.7062495900330854 0.7062485680342645 -1.4333444086842007e-07 -0.09951510465442641 +1.9813000000000003 0.7062498490712934 0.7062488291564584 -1.405978175671868e-07 -0.09951525159957479 +1.9814 0.7062501080604129 0.7062490901702998 -1.3783955997784259e-07 -0.09951539850030032 +1.9815 0.7062503670006919 0.7062493510755885 -1.3506030956123016e-07 -0.09951554535661636 +1.9816 0.7062506258923714 0.7062496118721311 -1.3226071239255677e-07 -0.09951569216853627 +1.9817 0.7062508847356856 0.7062498725597408 -1.2944141906424955e-07 -0.09951583893607348 +1.9818000000000002 0.7062511435308614 0.706250133138238 -1.266030844864624e-07 -0.09951598565924125 +1.9819 0.7062514022781186 0.7062503936074502 -1.2374636776738002e-07 -0.09951613233805295 +1.982 0.70625166097767 0.7062506539672124 -1.2087193205362334e-07 -0.09951627897252195 +1.9821000000000002 0.7062519196297212 0.7062509142173661 -1.1798044436545085e-07 -0.09951642556266158 +1.9822 0.7062521782344708 0.7062511743577604 -1.1507257544930705e-07 -0.09951657210848518 +1.9823000000000002 0.7062524367921097 0.7062514343882516 -1.1214899963037095e-07 -0.09951671861000608 +1.9824000000000002 0.7062526953028216 0.7062516943087032 -1.092103946338796e-07 -0.0995168650672376 +1.9825 0.7062529537667832 0.7062519541189856 -1.0625744146369742e-07 -0.09951701148019305 +1.9826000000000001 0.7062532121841638 0.7062522138189773 -1.0329082419848618e-07 -0.09951715784888576 +1.9827000000000001 0.7062534705551251 0.706252473408564 -1.0031122987200908e-07 -0.0995173041733291 +1.9828000000000001 0.7062537288798214 0.7062527328876382 -9.731934829705635e-08 -0.09951745045353633 +1.9829 0.7062539871583997 0.7062529922561003 -9.431587191365692e-08 -0.09951759668952068 +1.983 0.7062542453909995 0.7062532515138582 -9.130149561820816e-08 -0.09951774288129556 +1.9831 0.7062545035777525 0.7062535106608273 -8.827691661255493e-08 -0.09951788902887426 +1.9832 0.7062547617187838 0.70625376969693 -8.524283423225198e-08 -0.09951803513227003 +1.9833000000000003 0.7062550198142099 0.7062540286220972 -8.219994979651035e-08 -0.09951818119149625 +1.9834 0.70625527786414 0.7062542874362663 -7.914896644253128e-08 -0.09951832720656616 +1.9835 0.7062555358686764 0.7062545461393828 -7.609058895810539e-08 -0.09951847317749302 +1.9836 0.7062557938279128 0.7062548047313992 -7.302552362635495e-08 -0.09951861910429005 +1.9837 0.7062560517419362 0.7062550632122768 -6.995447805833305e-08 -0.09951876498697065 +1.9838000000000002 0.7062563096108256 0.7062553215819835 -6.687816102562277e-08 -0.09951891082554812 +1.9839 0.7062565674346521 0.7062555798404949 -6.37972823068142e-08 -0.0995190566200356 +1.984 0.7062568252134798 0.7062558379877943 -6.071255251489938e-08 -0.09951920237044638 +1.9841000000000002 0.7062570829473644 0.7062560960238731 -5.7624682941147254e-08 -0.09951934807679381 +1.9842 0.7062573406363546 0.7062563539487297 -5.45343853816313e-08 -0.09951949373909107 +1.9843000000000002 0.7062575982804911 0.7062566117623703 -5.144237198240545e-08 -0.09951963935735139 +1.9844000000000002 0.7062578558798073 0.7062568694648091 -4.8349355069826454e-08 -0.09951978493158813 +1.9845 0.7062581134343284 0.7062571270560676 -4.525604698992934e-08 -0.09951993046181447 +1.9846000000000001 0.7062583709440723 0.7062573845361748 -4.216315994099947e-08 -0.09952007594804362 +1.9847000000000001 0.7062586284090493 0.7062576419051676 -3.9071405812704085e-08 -0.09952022139028882 +1.9848000000000001 0.706258885829262 0.7062578991630905 -3.59814960217272e-08 -0.09952036678856338 +1.9849 0.7062591432047052 0.7062581563099953 -3.289414134632039e-08 -0.09952051214288044 +1.985 0.7062594005353666 0.7062584133459417 -2.981005176256116e-08 -0.09952065745325328 +1.9851 0.7062596578212254 0.7062586702709974 -2.6729936285869657e-08 -0.0995208027196951 +1.9852 0.7062599150622538 0.706258927085237 -2.3654502802686328e-08 -0.0995209479422191 +1.9853000000000003 0.7062601722584163 0.7062591837887426 -2.0584457909901543e-08 -0.09952109312083848 +1.9854 0.7062604294096702 0.7062594403816047 -1.7520506754610532e-08 -0.09952123825556651 +1.9855 0.7062606865159644 0.7062596968639208 -1.4463352870398849e-08 -0.09952138334641639 +1.9856 0.7062609435772411 0.7062599532357954 -1.1413698010592083e-08 -0.09952152839340127 +1.9857 0.7062612005934348 0.7062602094973416 -8.372242000370678e-09 -0.0995216733965344 +1.9858000000000002 0.7062614575644719 0.7062604656486791 -5.3396825598281406e-09 -0.09952181835582892 +1.9859 0.7062617144902719 0.7062607216899357 -2.3167151582542678e-09 -0.09952196327129806 +1.986 0.7062619713707468 0.7062609776212458 6.959671545667123e-10 -0.09952210814295498 +1.9861000000000002 0.7062622282058011 0.7062612334427525 3.697673902312848e-09 -0.09952225297081292 +1.9862 0.7062624849953322 0.7062614891546048 6.687717338249577e-09 -0.09952239775488504 +1.9863000000000002 0.7062627417392295 0.7062617447569599 9.66541261176318e-09 -0.09952254249518445 +1.9864000000000002 0.7062629984373758 0.7062620002499821 1.2630077918414362e-08 -0.09952268719172436 +1.9865 0.7062632550896457 0.7062622556338429 1.5581034657798087e-08 -0.0995228318445179 +1.9866000000000001 0.706263511695908 0.706262510908721 1.8517607586199247e-08 -0.09952297645357827 +1.9867000000000001 0.7062637682560231 0.7062627660748031 2.1439124970115686e-08 -0.09952312101891872 +1.9868000000000001 0.7062640247698445 0.7062630211322818 2.4344918747587485e-08 -0.0995232655405523 +1.9869 0.7062642812372185 0.7062632760813574 2.723432468085263e-08 -0.09952341001849213 +1.987 0.7062645376579846 0.7062635309222371 3.010668249425752e-08 -0.09952355445275142 +1.9871 0.7062647940319752 0.7062637856551357 3.296133603732099e-08 -0.09952369884334328 +1.9872 0.7062650503590153 0.7062640402802742 3.579763343565523e-08 -0.09952384319028085 +1.9873000000000003 0.706265306638924 0.7062642947978809 3.861492722627424e-08 -0.09952398749357727 +1.9874 0.7062655628715119 0.7062645492081913 4.141257452412728e-08 -0.09952413175324569 +1.9875 0.706265819056584 0.706264803511447 4.418993716087671e-08 -0.09952427596929923 +1.9876 0.7062660751939385 0.7062650577078973 4.6946381815002325e-08 -0.09952442014175102 +1.9877 0.7062663312833657 0.7062653117977971 4.9681280185273624e-08 -0.09952456427061412 +1.9878000000000002 0.7062665873246505 0.7062655657814088 5.239400911044578e-08 -0.09952470835590167 +1.9879 0.706266843317571 0.7062658196590015 5.508395071671113e-08 -0.09952485239762691 +1.988 0.7062670992618978 0.7062660734308503 5.775049256862008e-08 -0.09952499639580278 +1.9881000000000002 0.7062673551573957 0.7062663270972374 6.039302779224653e-08 -0.09952514035044245 +1.9882 0.7062676110038232 0.7062665806584506 6.301095523651712e-08 -0.09952528426155904 +1.9883000000000002 0.7062678668009319 0.7062668341147849 6.560367958076407e-08 -0.0995254281291656 +1.9884000000000002 0.7062681225484673 0.7062670874665408 6.817061148564618e-08 -0.09952557195327517 +1.9885 0.7062683782461692 0.7062673407140261 7.071116773366137e-08 -0.09952571573390102 +1.9886000000000001 0.7062686338937703 0.7062675938575538 7.322477135057737e-08 -0.09952585947105609 +1.9887000000000001 0.7062688894909976 0.7062678468974435 7.571085173900538e-08 -0.09952600316475349 +1.9888000000000001 0.706269145037572 0.7062680998340207 7.816884480676967e-08 -0.0995261468150063 +1.9889000000000001 0.7062694005332083 0.706268352667617 8.05981930987465e-08 -0.09952629042182755 +1.989 0.7062696559776158 0.7062686053985698 8.299834592349897e-08 -0.0995264339852304 +1.9891 0.706269911370498 0.7062688580272224 8.536875946256461e-08 -0.09952657750522786 +1.9892 0.7062701667115516 0.7062691105539234 8.770889692831518e-08 -0.09952672098183302 +1.9893000000000003 0.7062704220004692 0.7062693629790275 9.00182286454887e-08 -0.09952686441505891 +1.9894 0.7062706772369362 0.7062696153028951 9.229623220557981e-08 -0.09952700780491855 +1.9895 0.7062709324206335 0.7062698675258917 9.45423925466371e-08 -0.09952715115142502 +1.9896 0.7062711875512366 0.7062701196483885 9.675620210591873e-08 -0.0995272944545914 +1.9897 0.7062714426284152 0.7062703716707619 9.89371609187717e-08 -0.09952743771443068 +1.9898000000000002 0.706271697651834 0.7062706235933938 1.0108477672618466e-07 -0.09952758093095596 +1.9899 0.7062719526211522 0.7062708754166709 1.0319856511356584e-07 -0.09952772410418019 +1.99 0.7062722075360239 0.7062711271409854 1.0527804957319309e-07 -0.09952786723411644 +1.9901000000000002 0.7062724623960985 0.7062713787667343 1.0732276166380839e-07 -0.09952801032077774 +1.9902 0.7062727172010206 0.7062716302943195 1.0933224105225126e-07 -0.09952815336417714 +1.9903000000000002 0.7062729719504293 0.7062718817241478 1.113060356799922e-07 -0.0995282963643276 +1.9904000000000002 0.7062732266439598 0.7062721330566308 1.1324370183946053e-07 -0.09952843932124222 +1.9905 0.7062734812812415 0.7062723842921845 1.1514480426771945e-07 -0.09952858223493391 +1.9906000000000001 0.7062737358619005 0.7062726354312296 1.1700891625054943e-07 -0.09952872510541573 +1.9907000000000001 0.7062739903855573 0.7062728864741912 1.1883561971612333e-07 -0.09952886793270066 +1.9908000000000001 0.7062742448518289 0.7062731374214989 1.2062450533215086e-07 -0.09952901071680167 +1.9909000000000001 0.7062744992603275 0.7062733882735868 1.2237517259608421e-07 -0.09952915345773186 +1.991 0.7062747536106613 0.7062736390308928 1.2408722991144594e-07 -0.09952929615550415 +1.9911 0.706275007902434 0.706273889693859 1.2576029471272898e-07 -0.09952943881013153 +1.9912 0.7062752621352463 0.7062741402629313 1.2739399350009117e-07 -0.09952958142162699 +1.9913000000000003 0.7062755163086936 0.7062743907385598 1.2898796196078588e-07 -0.09952972399000348 +1.9914 0.7062757704223686 0.7062746411211981 1.3054184504895927e-07 -0.09952986651527398 +1.9915 0.7062760244758599 0.706274891411304 1.3205529703075314e-07 -0.09953000899745151 +1.9916 0.7062762784687524 0.7062751416093382 1.3352798159879664e-07 -0.099530151436549 +1.9917 0.7062765324006282 0.7062753917157655 1.3495957191383967e-07 -0.0995302938325795 +1.9918000000000002 0.7062767862710648 0.7062756417310534 1.3634975070883626e-07 -0.09953043618555579 +1.9919 0.7062770400796374 0.7062758916556736 1.3769821035486407e-07 -0.09953057849549102 +1.992 0.7062772938259174 0.7062761414901002 1.3900465290275776e-07 -0.09953072076239804 +1.9921000000000002 0.7062775475094734 0.7062763912348102 1.402687901802535e-07 -0.09953086298628973 +1.9922 0.7062778011298712 0.7062766408902847 1.4149034383362236e-07 -0.09953100516717918 +1.9923000000000002 0.7062780546866733 0.7062768904570064 1.426690453935897e-07 -0.0995311473050792 +1.9924000000000002 0.7062783081794399 0.7062771399354617 1.4380463632043816e-07 -0.09953128940000285 +1.9925 0.7062785616077281 0.7062773893261391 1.4489686811849922e-07 -0.09953143145196301 +1.9926000000000001 0.7062788149710926 0.70627763862953 1.459455023188061e-07 -0.09953157346097258 +1.9927000000000001 0.7062790682690858 0.7062778878461276 1.4695031057276875e-07 -0.09953171542704456 +1.9928000000000001 0.7062793215012576 0.7062781369764277 1.4791107467299058e-07 -0.09953185735019172 +1.9929000000000001 0.706279574667156 0.7062783860209291 1.4882758662612683e-07 -0.09953199923042716 +1.993 0.7062798277663266 0.7062786349801315 1.4969964871186514e-07 -0.0995321410677637 +1.9931 0.7062800807983127 0.7062788838545375 1.5052707346210892e-07 -0.09953228286221426 +1.9932 0.7062803337626565 0.7062791326446507 1.5130968377546905e-07 -0.09953242461379175 +1.9933 0.7062805866588977 0.7062793813509773 1.5204731289644724e-07 -0.09953256632250905 +1.9934 0.7062808394865745 0.7062796299740248 1.5273980449176383e-07 -0.09953270798837908 +1.9935 0.7062810922452238 0.7062798785143021 1.5338701267464394e-07 -0.09953284961141474 +1.9936 0.706281344934381 0.7062801269723198 1.53988802001348e-07 -0.0995329911916289 +1.9937 0.7062815975535799 0.70628037534859 1.5454504752321352e-07 -0.09953313272903451 +1.9938000000000002 0.7062818501023534 0.7062806236436253 1.550556348421661e-07 -0.09953327422364439 +1.9939 0.7062821025802332 0.7062808718579401 1.5552046010031129e-07 -0.09953341567547146 +1.994 0.7062823549867494 0.7062811199920489 1.5593942999381216e-07 -0.09953355708452848 +1.9941000000000002 0.7062826073214324 0.7062813680464682 1.5631246179717562e-07 -0.09953369845082843 +1.9942 0.706282859583811 0.7062816160217145 1.566394834083551e-07 -0.09953383977438417 +1.9943000000000002 0.7062831117734136 0.706281863918305 1.5692043332793393e-07 -0.09953398105520851 +1.9944000000000002 0.7062833638897681 0.706282111736758 1.5715526066606422e-07 -0.09953412229331442 +1.9945 0.7062836159324017 0.7062823594775913 1.5734392519797802e-07 -0.09953426348871464 +1.9946000000000002 0.7062838679008417 0.706282607141324 1.5748639733276226e-07 -0.09953440464142212 +1.9947000000000001 0.706284119794615 0.7062828547284741 1.5758265809601157e-07 -0.09953454575144963 +1.9948000000000001 0.7062843716132484 0.7062831022395607 1.5763269919574774e-07 -0.09953468681881004 +1.9949000000000001 0.7062846233562684 0.7062833496751025 1.5763652294262243e-07 -0.09953482784351611 +1.995 0.7062848750232025 0.7062835970356184 1.5759414232971447e-07 -0.09953496882558083 +1.9951 0.7062851266135778 0.7062838443216265 1.5750558094232425e-07 -0.09953510976501695 +1.9952 0.7062853781269222 0.7062840915336448 1.5737087302042374e-07 -0.09953525066183734 +1.9953 0.7062856295627635 0.7062843386721905 1.571900634066148e-07 -0.0995353915160548 +1.9954 0.7062858809206305 0.7062845857377806 1.5696320754612914e-07 -0.09953553232768213 +1.9955 0.7062861322000528 0.7062848327309309 1.5669037147295062e-07 -0.09953567309673214 +1.9956 0.7062863834005605 0.7062850796521569 1.5637163177859015e-07 -0.09953581382321768 +1.9957 0.7062866345216849 0.7062853265019728 1.5600707561555516e-07 -0.09953595450715154 +1.9958000000000002 0.7062868855629585 0.7062855732808915 1.5559680064183845e-07 -0.0995360951485465 +1.9959 0.7062871365239147 0.7062858199894255 1.5514091500704041e-07 -0.09953623574741546 +1.996 0.7062873874040884 0.7062860666280852 1.5463953734543012e-07 -0.09953637630377116 +1.9961000000000002 0.7062876382030152 0.7062863131973801 1.540927967204342e-07 -0.09953651681762637 +1.9962 0.7062878889202333 0.7062865596978176 1.5350083260728953e-07 -0.0995366572889939 +1.9963000000000002 0.7062881395552819 0.7062868061299041 1.5286379485487944e-07 -0.09953679771788654 +1.9964000000000002 0.706288390107702 0.7062870524941438 1.5218184363022247e-07 -0.09953693810431707 +1.9965 0.7062886405770363 0.7062872987910396 1.5145514939418625e-07 -0.09953707844829827 +1.9966000000000002 0.7062888909628298 0.7062875450210919 1.5068389287026251e-07 -0.09953721874984298 +1.9967000000000001 0.706289141264629 0.7062877911847991 1.4986826498558647e-07 -0.09953735900896385 +1.9968000000000001 0.7062893914819833 0.7062880372826578 1.4900846682236457e-07 -0.09953749922567373 +1.9969000000000001 0.7062896416144437 0.7062882833151618 1.4810470956930222e-07 -0.09953763939998533 +1.997 0.706289891661564 0.7062885292828028 1.471572144695621e-07 -0.09953777953191148 +1.9971 0.7062901416229003 0.7062887751860699 1.4616621277913078e-07 -0.09953791962146485 +1.9972 0.7062903914980116 0.7062890210254498 1.4513194570783816e-07 -0.09953805966865825 +1.9973 0.7062906412864591 0.706289266801426 1.4405466433262126e-07 -0.09953819967350443 +1.9974 0.7062908909878074 0.70628951251448 1.4293462955936032e-07 -0.09953833963601616 +1.9975 0.7062911406016233 0.7062897581650895 1.417721120812454e-07 -0.09953847955620614 +1.9976 0.7062913901274774 0.7062900037537299 1.4056739226775417e-07 -0.09953861943408714 +1.9977 0.7062916395649426 0.7062902492808725 1.3932076015424344e-07 -0.09953875926967182 +1.9978000000000002 0.7062918889135956 0.7062904947469864 1.380325153031714e-07 -0.09953889906297296 +1.9979 0.7062921381730165 0.7062907401525367 1.3670296677981142e-07 -0.09953903881400328 +1.998 0.7062923873427884 0.7062909854979855 1.353324330724548e-07 -0.09953917852277552 +1.9981000000000002 0.7062926364224983 0.7062912307837914 1.3392124200220512e-07 -0.09953931818930245 +1.9982 0.7062928854117365 0.7062914760104084 1.324697306639977e-07 -0.09953945781359667 +1.9983000000000002 0.7062931343100972 0.706291721178288 1.3097824532251612e-07 -0.09953959739567098 +1.9984000000000002 0.7062933831171785 0.706291966287877 1.2944714136015056e-07 -0.09953973693553803 +1.9985 0.7062936318325822 0.7062922113396191 1.2787678314862827e-07 -0.09953987643321055 +1.9986000000000002 0.7062938804559142 0.7062924563339528 1.2626754399697182e-07 -0.0995400158887012 +1.9987000000000001 0.7062941289867847 0.7062927012713136 1.2461980607170187e-07 -0.09954015530202276 +1.9988000000000001 0.7062943774248076 0.7062929461521322 1.2293396027887593e-07 -0.09954029467318781 +1.9989000000000001 0.7062946257696021 0.7062931909768353 1.21210406160005e-07 -0.09954043400220919 +1.999 0.7062948740207904 0.706293435745845 1.1944955185042017e-07 -0.09954057328909945 +1.9991 0.7062951221780005 0.7062936804595789 1.1765181393008639e-07 -0.09954071253387131 +1.9992 0.7062953702408639 0.7062939251184499 1.1581761736809137e-07 -0.09954085173653748 +1.9993 0.7062956182090172 0.7062941697228664 1.1394739538039822e-07 -0.09954099089711056 +1.9994 0.7062958660821022 0.7062944142732324 1.1204158935004815e-07 -0.09954113001560329 +1.9995 0.7062961138597645 0.7062946587699462 1.1010064872654657e-07 -0.0995412690920283 +1.9996 0.7062963615416556 0.7062949032134018 1.0812503091137127e-07 -0.09954140812639821 +1.9997 0.7062966091274321 0.7062951476039886 1.0611520114695017e-07 -0.09954154711872586 +1.9998000000000002 0.7062968566167543 0.7062953919420898 1.0407163242645567e-07 -0.09954168606902371 +1.9999 0.706297104009289 0.7062956362280842 1.019948053619657e-07 -0.09954182497730452 +2.0 0.7062973513047078 0.7062958804623449 9.988520808384971e-08 -0.09954196384358088 +2.0001 0.7062975985026874 0.7062961246452402 9.774333610892971e-08 -0.09954210266786545 +2.0002 0.7062978456029103 0.7062963687771322 9.556969225721357e-08 -0.09954224145017083 +2.0003 0.7062980926050642 0.7062966128583784 9.33647864923004e-08 -0.0995423801905097 +2.0004 0.7062983395088425 0.7062968568893304 9.112913583811388e-08 -0.09954251888889475 +2.0005 0.7062985863139443 0.7062971008703338 8.886326421930768e-08 -0.0995426575453385 +2.0006 0.7062988330200739 0.7062973448017291 8.656770240228484e-08 -0.09954279615985365 +2.0007 0.706299079626942 0.7062975886838501 8.424298778876571e-08 -0.09954293473245274 +2.0008000000000004 0.7062993261342652 0.7062978325170257 8.188966435854206e-08 -0.09954307326314847 +2.0009 0.706299572541765 0.7062980763015786 7.950828250467834e-08 -0.09954321175195341 +2.001 0.70629981884917 0.7062983200378252 7.709939892075468e-08 -0.09954335019888017 +2.0011 0.7063000650562141 0.7062985637260759 7.466357646208899e-08 -0.0995434886039413 +2.0012 0.7063003111626383 0.7062988073666356 7.220138401910214e-08 -0.09954362696714951 +2.0013 0.7063005571681882 0.7062990509598024 6.971339638200957e-08 -0.09954376528851733 +2.0014000000000003 0.7063008030726174 0.7062992945058684 6.720019410030864e-08 -0.09954390356805745 +2.0015 0.7063010488756843 0.7062995380051191 6.46623633682869e-08 -0.09954404180578237 +2.0016000000000003 0.7063012945771545 0.7062997814578342 6.210049587930533e-08 -0.09954418000170472 +2.0017 0.7063015401767998 0.7063000248642859 5.951518866273431e-08 -0.09954431815583702 +2.0018000000000002 0.7063017856743985 0.7063002682247413 5.690704399548274e-08 -0.09954445626819193 +2.0019 0.7063020310697351 0.7063005115394598 5.4276669202504846e-08 -0.09954459433878195 +2.002 0.7063022763626011 0.7063007548086951 5.162467655792091e-08 -0.09954473236761967 +2.0021 0.7063025215527945 0.7063009980326937 4.8951683132361645e-08 -0.09954487035471768 +2.0022 0.70630276664012 0.7063012412116958 4.625831064725139e-08 -0.09954500830008857 +2.0023 0.7063030116243887 0.7063014843459343 4.354518532388718e-08 -0.09954514620374483 +2.0024 0.7063032565054188 0.7063017274356358 4.08129377533345e-08 -0.09954528406569906 +2.0025 0.7063035012830352 0.7063019704810203 3.80622027298938e-08 -0.09954542188596381 +2.0026 0.7063037459570698 0.7063022134822999 3.529361912273099e-08 -0.09954555966455157 +2.0027 0.7063039905273611 0.7063024564396813 3.2507829721487025e-08 -0.09954569740147497 +2.0028 0.7063042349937549 0.7063026993533629 2.9705481073213913e-08 -0.09954583509674651 +2.0029 0.7063044793561039 0.7063029422235367 2.688722335747462e-08 -0.09954597275037878 +2.003 0.7063047236142674 0.7063031850503878 2.405371020419711e-08 -0.09954611036238423 +2.0031000000000003 0.7063049677681126 0.7063034278340938 2.1205598579182583e-08 -0.09954624793277551 +2.0032 0.7063052118175126 0.7063036705748256 1.8343548601092163e-08 -0.09954638546156501 +2.0033000000000003 0.7063054557623485 0.7063039132727468 1.5468223409607906e-08 -0.09954652294876531 +2.0034 0.7063056996025083 0.7063041559280139 1.2580288993695177e-08 -0.09954666039438897 +2.0035 0.7063059433378872 0.706304398540776 9.680414051090047e-09 -0.09954679779844844 +2.0036 0.7063061869683875 0.7063046411111754 6.769269825235291e-09 -0.09954693516095625 +2.0037000000000003 0.7063064304939188 0.7063048836393468 3.847529957828888e-09 -0.09954707248192493 +2.0038 0.7063066739143982 0.7063051261254181 9.158703274947388e-10 -0.09954720976136702 +2.0039000000000002 0.7063069172297494 0.7063053685695089 -2.025031110679254e-09 -0.0995473469992949 +2.004 0.7063071604399043 0.7063056109717327 -4.9744944717253214e-09 -0.0995474841957212 +2.0041 0.7063074035448013 0.7063058533321952 -7.931838101257749e-09 -0.09954762135065837 +2.0042 0.7063076465443866 0.7063060956509944 -1.0896378735934797e-08 -0.0995477584641189 +2.0043 0.7063078894386134 0.7063063379282213 -1.3867431664787988e-08 -0.0995478955361152 +2.0044 0.7063081322274423 0.7063065801639594 -1.6844310876239915e-08 -0.09954803256665978 +2.0045 0.7063083749108421 0.7063068223582853 -1.98263292246377e-08 -0.09954816955576523 +2.0046 0.7063086174887876 0.7063070645112676 -2.281279858767915e-08 -0.09954830650344393 +2.0047 0.706308859961262 0.7063073066229674 -2.5803030021670503e-08 -0.09954844340970832 +2.0048000000000004 0.7063091023282555 0.7063075486934389 -2.879633392502412e-08 -0.09954858027457093 +2.0049 0.706309344589766 0.7063077907227289 -3.179202019481728e-08 -0.0995487170980442 +2.005 0.7063095867457985 0.7063080327108766 -3.478939838616989e-08 -0.09954885388014068 +2.0051 0.706309828796365 0.7063082746579132 -3.778777786967065e-08 -0.09954899062087265 +2.0052 0.7063100707414862 0.7063085165638637 -4.078646799341107e-08 -0.09954912732025273 +2.0053 0.7063103125811888 0.7063087584287444 -4.378477824019478e-08 -0.09954926397829322 +2.0054000000000003 0.7063105543155077 0.7063090002525653 -4.678201838767418e-08 -0.09954940059500667 +2.0055 0.706310795944485 0.7063092420353283 -4.977749866615609e-08 -0.09954953717040547 +2.0056000000000003 0.70631103746817 0.7063094837770278 -5.2770529915648415e-08 -0.09954967370450209 +2.0057 0.7063112788866199 0.7063097254776516 -5.5760423749466256e-08 -0.09954981019730894 +2.0058000000000002 0.7063115201998987 0.7063099671371793 -5.8746492706453907e-08 -0.09954994664883844 +2.0059 0.7063117614080782 0.7063102087555839 -6.172805041204307e-08 -0.0995500830591031 +2.006 0.706312002511237 0.7063104503328298 -6.470441173914848e-08 -0.09955021942811525 +2.0061 0.7063122435094618 0.7063106918688754 -6.767489295778778e-08 -0.09955035575588732 +2.0062 0.7063124844028457 0.7063109333636712 -7.063881190053078e-08 -0.09955049204243177 +2.0063 0.7063127251914897 0.7063111748171602 -7.359548811255306e-08 -0.09955062828776094 +2.0064 0.7063129658755023 0.7063114162292785 -7.654424300992946e-08 -0.09955076449188735 +2.0065 0.7063132064549984 0.7063116575999547 -7.948440003489182e-08 -0.0995509006548233 +2.0066 0.7063134469301007 0.7063118989291102 -8.241528481282151e-08 -0.09955103677658123 +2.0067 0.7063136873009392 0.7063121402166592 -8.533622530924184e-08 -0.09955117285717352 +2.0068 0.7063139275676507 0.7063123814625087 -8.824655197553488e-08 -0.09955130889661253 +2.0069 0.7063141677303797 0.7063126226665591 -9.114559790940335e-08 -0.0995514448949108 +2.007 0.7063144077892769 0.7063128638287025 -9.403269900492423e-08 -0.09955158085208055 +2.0071000000000003 0.706314647744501 0.7063131049488247 -9.690719410433701e-08 -0.0995517167681342 +2.0072 0.7063148875962174 0.7063133460268043 -9.976842515330153e-08 -0.0995518526430842 +2.0073000000000003 0.7063151273445982 0.7063135870625128 -1.0261573734401258e-07 -0.09955198847694284 +2.0074 0.7063153669898232 0.7063138280558148 -1.0544847927566187e-07 -0.09955212426972254 +2.0075 0.7063156065320784 0.7063140690065681 -1.0826600308714435e-07 -0.09955226002143565 +2.0076 0.7063158459715568 0.7063143099146232 -1.1106766462966322e-07 -0.09955239573209454 +2.0077000000000003 0.7063160853084591 0.7063145507798236 -1.1385282358208904e-07 -0.09955253140171152 +2.0078 0.7063163245429915 0.7063147916020068 -1.1662084362790148e-07 -0.099552667030299 +2.0079000000000002 0.7063165636753684 0.706315032381003 -1.1937109258355894e-07 -0.09955280261786938 +2.008 0.7063168027058101 0.7063152731166356 -1.221029425398784e-07 -0.09955293816443497 +2.0081 0.7063170416345428 0.706315513808721 -1.2481577002509958e-07 -0.09955307367000804 +2.0082 0.7063172804618012 0.70631575445707 -1.2750895612458069e-07 -0.09955320913460104 +2.0083 0.7063175191878248 0.7063159950614853 -1.301818866334542e-07 -0.09955334455822622 +2.0084 0.706317757812861 0.7063162356217645 -1.3283395219713945e-07 -0.09955347994089593 +2.0085 0.7063179963371626 0.7063164761376981 -1.3546454844144684e-07 -0.09955361528262255 +2.0086 0.7063182347609896 0.70631671660907 -1.380730761200294e-07 -0.09955375058341837 +2.0087 0.706318473084608 0.7063169570356582 -1.406589412462217e-07 -0.09955388584329573 +2.0088000000000004 0.70631871130829 0.7063171974172336 -1.4322155523528723e-07 -0.09955402106226693 +2.0089 0.7063189494323142 0.7063174377535618 -1.4576033501197128e-07 -0.09955415624034426 +2.009 0.7063191874569654 0.7063176780444019 -1.482747031926468e-07 -0.09955429137754014 +2.0091 0.7063194253825347 0.7063179182895065 -1.507640881668465e-07 -0.0995544264738668 +2.0092 0.7063196632093185 0.7063181584886222 -1.5322792425685738e-07 -0.09955456152933653 +2.0093 0.7063199009376202 0.7063183986414902 -1.5566565182874303e-07 -0.09955469654396167 +2.0094000000000003 0.7063201385677487 0.7063186387478447 -1.5807671743632568e-07 -0.09955483151775449 +2.0095 0.7063203761000183 0.7063188788074153 -1.6046057393220847e-07 -0.09955496645072733 +2.0096000000000003 0.7063206135347496 0.7063191188199248 -1.6281668060308396e-07 -0.0995551013428924 +2.0097 0.7063208508722688 0.7063193587850904 -1.6514450328075636e-07 -0.09955523619426199 +2.0098000000000003 0.7063210881129081 0.7063195987026245 -1.6744351447398054e-07 -0.09955537100484849 +2.0099 0.7063213252570044 0.7063198385722327 -1.6971319347428016e-07 -0.09955550577466406 +2.01 0.7063215623049008 0.7063200783936159 -1.7195302648952138e-07 -0.09955564050372101 +2.0101 0.7063217992569462 0.7063203181664697 -1.7416250676187406e-07 -0.09955577519203171 +2.0102 0.7063220361134932 0.7063205578904833 -1.763411346528132e-07 -0.09955590983960827 +2.0103 0.7063222728749017 0.7063207975653418 -1.7848841779924407e-07 -0.09955604444646306 +2.0104 0.7063225095415353 0.7063210371907247 -1.806038711880953e-07 -0.09955617901260833 +2.0105 0.7063227461137633 0.7063212767663057 -1.8268701730203563e-07 -0.09955631353805627 +2.0106 0.7063229825919601 0.7063215162917545 -1.8473738617671986e-07 -0.09955644802281918 +2.0107 0.7063232189765051 0.7063217557667355 -1.8675451554650557e-07 -0.09955658246690935 +2.0108 0.7063234552677818 0.7063219951909077 -1.8873795093812817e-07 -0.09955671687033893 +2.0109 0.7063236914661793 0.7063222345639261 -1.906872457782538e-07 -0.0995568512331202 +2.011 0.7063239275720913 0.7063224738854406 -1.9260196146980713e-07 -0.09955698555526547 +2.0111000000000003 0.7063241635859157 0.7063227131550963 -1.9448166753768814e-07 -0.09955711983678689 +2.0112 0.7063243995080553 0.7063229523725346 -1.9632594167387496e-07 -0.09955725407769678 +2.0113000000000003 0.7063246353389172 0.7063231915373913 -1.9813436987273225e-07 -0.0995573882780073 +2.0114 0.7063248710789125 0.7063234306492985 -1.9990654647611406e-07 -0.09955752243773065 +2.0115 0.706325106728457 0.7063236697078842 -2.0164207432601944e-07 -0.09955765655687913 +2.0116 0.7063253422879707 0.7063239087127717 -2.033405648166342e-07 -0.09955779063546488 +2.0117000000000003 0.706325577757877 0.7063241476635804 -2.0500163797759763e-07 -0.09955792467350012 +2.0118 0.7063258131386037 0.7063243865599266 -2.0662492256420806e-07 -0.09955805867099711 +2.0119000000000002 0.7063260484305829 0.7063246254014213 -2.08210056151098e-07 -0.09955819262796803 +2.012 0.7063262836342495 0.7063248641876725 -2.097566852050925e-07 -0.09955832654442504 +2.0121 0.7063265187500434 0.7063251029182845 -2.112644651650064e-07 -0.09955846042038041 +2.0122 0.7063267537784066 0.706325341592858 -2.127330605145028e-07 -0.09955859425584629 +2.0123 0.7063269887197854 0.7063255802109899 -2.1416214486535967e-07 -0.09955872805083489 +2.0124 0.7063272235746297 0.7063258187722743 -2.155514010129811e-07 -0.09955886180535842 +2.0125 0.7063274583433923 0.7063260572763012 -2.169005210300723e-07 -0.09955899551942905 +2.0126 0.706327693026529 0.7063262957226579 -2.182092063221508e-07 -0.09955912919305894 +2.0127 0.7063279276244989 0.7063265341109285 -2.1947716769693537e-07 -0.09955926282626024 +2.0128000000000004 0.7063281621377644 0.7063267724406943 -2.2070412541985718e-07 -0.09955939641904521 +2.0129 0.7063283965667899 0.7063270107115336 -2.2188980927997926e-07 -0.09955952997142592 +2.013 0.7063286309120437 0.7063272489230217 -2.2303395866285491e-07 -0.0995596634834146 +2.0131 0.706328865173996 0.7063274870747313 -2.2413632257134442e-07 -0.09955979695502337 +2.0132 0.7063290993531197 0.7063277251662328 -2.2519665973316783e-07 -0.09955993038626446 +2.0133 0.7063293334498902 0.7063279631970936 -2.2621473859049668e-07 -0.0995600637771499 +2.0134000000000003 0.7063295674647856 0.7063282011668794 -2.271903374283235e-07 -0.09956019712769199 +2.0135 0.7063298013982858 0.7063284390751531 -2.281232443640535e-07 -0.09956033043790274 +2.0136000000000003 0.706330035250873 0.7063286769214757 -2.2901325737179068e-07 -0.09956046370779441 +2.0137 0.7063302690230315 0.7063289147054064 -2.2986018440029898e-07 -0.09956059693737913 +2.0138000000000003 0.7063305027152476 0.7063291524265014 -2.3066384337994128e-07 -0.09956073012666895 +2.0139 0.7063307363280089 0.7063293900843162 -2.3142406224696543e-07 -0.09956086327567608 +2.014 0.7063309698618054 0.7063296276784041 -2.3214067898513768e-07 -0.09956099638441263 +2.0141 0.7063312033171283 0.706329865208317 -2.328135416812538e-07 -0.09956112945289067 +2.0142 0.7063314366944705 0.7063301026736047 -2.3344250854248627e-07 -0.09956126248112239 +2.0143 0.7063316699943261 0.7063303400738166 -2.3402744790679275e-07 -0.09956139546911988 +2.0144 0.7063319032171907 0.7063305774084998 -2.34568238305366e-07 -0.09956152841689526 +2.0145 0.7063321363635608 0.7063308146772009 -2.3506476845916446e-07 -0.09956166132446066 +2.0146 0.7063323694339343 0.706331051879465 -2.3551693732401513e-07 -0.09956179419182812 +2.0147 0.7063326024288098 0.7063312890148363 -2.3592465410102181e-07 -0.09956192701900984 +2.0148 0.7063328353486867 0.7063315260828588 -2.3628783824697353e-07 -0.09956205980601786 +2.0149 0.7063330681940656 0.7063317630830745 -2.366064194986306e-07 -0.0995621925528643 +2.015 0.7063333009654471 0.7063320000150262 -2.3688033788660245e-07 -0.09956232525956127 +2.0151000000000003 0.7063335336633328 0.7063322368782549 -2.37109543745756e-07 -0.09956245792612084 +2.0152 0.7063337662882241 0.706332473672302 -2.3729399771521553e-07 -0.0995625905525551 +2.0153000000000003 0.7063339988406233 0.7063327103967081 -2.3743367075917954e-07 -0.09956272313887607 +2.0154 0.7063342313210328 0.7063329470510141 -2.3752854414957336e-07 -0.09956285568509597 +2.0155 0.7063344637299545 0.7063331836347606 -2.3757860948339649e-07 -0.09956298819122675 +2.0156 0.706334696067891 0.7063334201474878 -2.3758386867925307e-07 -0.09956312065728051 +2.0157 0.7063349283353443 0.7063336565887368 -2.3754433398082142e-07 -0.09956325308326931 +2.0158 0.7063351605328163 0.7063338929580485 -2.374600279395067e-07 -0.09956338546920526 +2.0159000000000002 0.7063353926608082 0.7063341292549643 -2.373309833901549e-07 -0.0995635178151004 +2.016 0.7063356247198211 0.706334365479026 -2.3715724348574718e-07 -0.09956365012096674 +2.0161000000000002 0.7063358567103557 0.706334601629776 -2.3693886163841937e-07 -0.0995637823868164 +2.0162 0.7063360886329114 0.7063348377067574 -2.3667590152293139e-07 -0.0995639146126614 +2.0163 0.7063363204879871 0.706335073709514 -2.3636843707319777e-07 -0.09956404679851374 +2.0164 0.7063365522760809 0.7063353096375908 -2.3601655244759323e-07 -0.09956417894438559 +2.0165 0.70633678399769 0.7063355454905338 -2.3562034199078874e-07 -0.09956431105028894 +2.0166 0.7063370156533094 0.7063357812678899 -2.3517991023722096e-07 -0.0995644431162358 +2.0167 0.7063372472434339 0.7063360169692069 -2.34695371893745e-07 -0.09956457514223818 +2.0168000000000004 0.706337478768557 0.7063362525940349 -2.3416685174595941e-07 -0.09956470712830816 +2.0169 0.7063377102291699 0.7063364881419245 -2.335944847033089e-07 -0.09956483907445773 +2.017 0.7063379416257629 0.7063367236124285 -2.3297841571928712e-07 -0.09956497098069889 +2.0171 0.7063381729588243 0.7063369590051012 -2.3231879977061998e-07 -0.09956510284704365 +2.0172 0.7063384042288409 0.7063371943194986 -2.316158018121628e-07 -0.09956523467350413 +2.0173 0.7063386354362973 0.7063374295551786 -2.3086959673179752e-07 -0.09956536646009226 +2.0174000000000003 0.7063388665816761 0.7063376647117012 -2.3008036931573828e-07 -0.09956549820682004 +2.0175 0.7063390976654582 0.706337899788628 -2.292483142034285e-07 -0.09956562991369948 +2.0176000000000003 0.7063393286881221 0.7063381347855239 -2.2837363585284653e-07 -0.0995657615807426 +2.0177 0.7063395596501432 0.706338369701955 -2.274565484537694e-07 -0.09956589320796137 +2.0178000000000003 0.7063397905519957 0.7063386045374904 -2.2649727590001723e-07 -0.09956602479536783 +2.0179 0.7063400213941506 0.7063388392917014 -2.254960517582283e-07 -0.0995661563429739 +2.018 0.7063402521770766 0.7063390739641622 -2.2445311912908106e-07 -0.09956628785079169 +2.0181 0.7063404829012392 0.7063393085544498 -2.2336873070627483e-07 -0.0995664193188331 +2.0182 0.7063407135671014 0.7063395430621435 -2.2224314861693517e-07 -0.09956655074711009 +2.0183 0.7063409441751228 0.7063397774868259 -2.2107664441814445e-07 -0.09956668213563463 +2.0184 0.7063411747257609 0.7063400118280827 -2.1986949897204178e-07 -0.09956681348441875 +2.0185 0.7063414052194692 0.7063402460855024 -2.1862200245970076e-07 -0.09956694479347435 +2.0186 0.7063416356566983 0.7063404802586768 -2.173344542458211e-07 -0.09956707606281343 +2.0187 0.7063418660378955 0.7063407143472016 -2.1600716281974797e-07 -0.09956720729244795 +2.0188 0.7063420963635049 0.706340948350675 -2.1464044574343033e-07 -0.09956733848238986 +2.0189 0.7063423266339662 0.7063411822686994 -2.1323462954733752e-07 -0.0995674696326511 +2.019 0.7063425568497163 0.7063414161008803 -2.1179004968188697e-07 -0.09956760074324363 +2.0191000000000003 0.7063427870111881 0.7063416498468272 -2.1030705041336084e-07 -0.09956773181417937 +2.0192 0.706343017118811 0.706341883506154 -2.0878598476492538e-07 -0.09956786284547034 +2.0193000000000003 0.7063432471730102 0.7063421170784772 -2.072272144021392e-07 -0.09956799383712844 +2.0194 0.7063434771742068 0.7063423505634179 -2.0563110958091158e-07 -0.09956812478916559 +2.0195 0.7063437071228178 0.7063425839606017 -2.0399804901219398e-07 -0.09956825570159371 +2.0196 0.7063439370192567 0.7063428172696579 -2.0232841984810235e-07 -0.09956838657442481 +2.0197 0.7063441668639319 0.70634305049022 -2.0062261752232247e-07 -0.09956851740767074 +2.0198 0.7063443966572479 0.7063432836219257 -1.9888104567725162e-07 -0.09956864820134342 +2.0199000000000003 0.7063446263996045 0.7063435166644175 -1.9710411606338463e-07 -0.0995687789554548 +2.02 0.7063448560913972 0.7063437496173426 -1.9529224847339433e-07 -0.09956890967001675 +2.0201000000000002 0.7063450857330167 0.7063439824803522 -1.9344587059294538e-07 -0.09956904034504123 +2.0202 0.7063453153248493 0.7063442152531025 -1.9156541794865256e-07 -0.09956917098054013 +2.0203 0.7063455448672761 0.7063444479352546 -1.8965133376930288e-07 -0.09956930157652533 +2.0204 0.7063457743606735 0.7063446805264741 -1.8770406890258884e-07 -0.09956943213300873 +2.0205 0.7063460038054135 0.7063449130264319 -1.8572408169714727e-07 -0.09956956265000227 +2.0206 0.7063462332018622 0.7063451454348035 -1.837118379054148e-07 -0.0995696931275178 +2.0207 0.7063464625503812 0.7063453777512696 -1.8166781055872772e-07 -0.0995698235655672 +2.0208000000000004 0.706346691851327 0.7063456099755161 -1.7959247987364702e-07 -0.0995699539641624 +2.0209 0.7063469211050502 0.7063458421072346 -1.774863331201193e-07 -0.09957008432331528 +2.021 0.706347150311897 0.7063460741461213 -1.7534986453474066e-07 -0.09957021464303772 +2.0211 0.7063473794722073 0.7063463060918782 -1.7318357517157046e-07 -0.09957034492334159 +2.0212 0.7063476085863156 0.7063465379442123 -1.7098797281019096e-07 -0.09957047516423868 +2.0213 0.7063478376545518 0.7063467697028369 -1.687635718273378e-07 -0.099570605365741 +2.0214000000000003 0.7063480666772395 0.7063470013674704 -1.6651089307893885e-07 -0.09957073552786032 +2.0215 0.7063482956546965 0.7063472329378366 -1.6423046377347927e-07 -0.09957086565060855 +2.0216000000000003 0.7063485245872354 0.7063474644136655 -1.6192281735057101e-07 -0.09957099573399752 +2.0217 0.7063487534751622 0.7063476957946927 -1.5958849335778735e-07 -0.09957112577803909 +2.0218000000000003 0.7063489823187779 0.7063479270806595 -1.5722803732576285e-07 -0.09957125578274506 +2.0219 0.7063492111183769 0.7063481582713136 -1.5484200064502796e-07 -0.09957138574812736 +2.022 0.706349439874248 0.7063483893664083 -1.5243094041855754e-07 -0.09957151567419781 +2.0221 0.7063496685866739 0.7063486203657029 -1.4999541934901384e-07 -0.0995716455609682 +2.0222 0.7063498972559309 0.7063488512689629 -1.475360056138464e-07 -0.09957177540845041 +2.0223 0.7063501258822893 0.7063490820759599 -1.450532727091669e-07 -0.09957190521665625 +2.0224 0.7063503544660135 0.7063493127864722 -1.425477993335228e-07 -0.09957203498559758 +2.0225 0.7063505830073612 0.7063495434002838 -1.4002016924738458e-07 -0.09957216471528622 +2.0226 0.7063508115065839 0.7063497739171848 -1.374709711413069e-07 -0.09957229440573395 +2.0227 0.7063510399639265 0.7063500043369725 -1.349007984936812e-07 -0.09957242405695263 +2.0228 0.7063512683796278 0.7063502346594499 -1.3231024943716196e-07 -0.09957255366895403 +2.0229 0.7063514967539202 0.706350464884427 -1.2969992661121532e-07 -0.09957268324175005 +2.023 0.7063517250870293 0.7063506950117199 -1.2707043704068832e-07 -0.09957281277535242 +2.0231000000000003 0.706351953379174 0.7063509250411515 -1.2442239196927551e-07 -0.09957294226977298 +2.0232 0.706352181630567 0.7063511549725511 -1.2175640673461885e-07 -0.0995730717250235 +2.0233000000000003 0.706352409841414 0.7063513848057548 -1.1907310062085619e-07 -0.09957320114111581 +2.0234 0.7063526380119143 0.7063516145406055 -1.1637309672331286e-07 -0.09957333051806172 +2.0235 0.7063528661422602 0.7063518441769527 -1.1365702178196824e-07 -0.09957345985587304 +2.0236 0.7063530942326375 0.7063520737146523 -1.1092550606002505e-07 -0.09957358915456149 +2.0237 0.7063533222832243 0.7063523031535675 -1.081791831808454e-07 -0.09957371841413884 +2.0238 0.7063535502941933 0.7063525324935682 -1.0541868999611181e-07 -0.09957384763461687 +2.0239000000000003 0.7063537782657092 0.7063527617345311 -1.0264466642363052e-07 -0.09957397681600742 +2.024 0.7063540061979303 0.7063529908763401 -9.985775530334945e-08 -0.09957410595832228 +2.0241000000000002 0.7063542340910078 0.7063532199188856 -9.705860225511093e-08 -0.09957423506157315 +2.0242 0.7063544619450859 0.7063534488620649 -9.424785552079179e-08 -0.09957436412577177 +2.0243 0.7063546897603019 0.7063536777057825 -9.142616582292346e-08 -0.09957449315092996 +2.0244 0.7063549175367859 0.7063539064499501 -8.859418620336262e-08 -0.09957462213705945 +2.0245 0.7063551452746613 0.7063541350944862 -8.575257188104396e-08 -0.099574751084172 +2.0246 0.7063553729740444 0.7063543636393167 -8.290198009585498e-08 -0.09957487999227944 +2.0247 0.706355600635044 0.7063545920843737 -8.004306995944982e-08 -0.09957500886139344 +2.0248000000000004 0.706355828257762 0.7063548204295973 -7.717650230172624e-08 -0.09957513769152573 +2.0249 0.7063560558422934 0.7063550486749339 -7.430293951556782e-08 -0.09957526648268807 +2.025 0.7063562833887258 0.706355276820338 -7.142304540895886e-08 -0.0995753952348922 +2.0251 0.7063565108971397 0.7063555048657705 -6.853748504538973e-08 -0.09957552394814985 +2.0252 0.706356738367609 0.7063557328111997 -6.564692460030858e-08 -0.09957565262247281 +2.0253 0.7063569658001997 0.7063559606566008 -6.275203119502151e-08 -0.09957578125787275 +2.0254000000000003 0.7063571931949706 0.7063561884019565 -5.985347275184322e-08 -0.09957590985436138 +2.0255 0.7063574205519736 0.7063564160472566 -5.6951917834285534e-08 -0.09957603841195044 +2.0256000000000003 0.7063576478712534 0.706356643592498 -5.404803549830493e-08 -0.09957616693065163 +2.0257 0.7063578751528476 0.7063568710376847 -5.1142495134442675e-08 -0.09957629541047672 +2.0258000000000003 0.7063581023967871 0.7063570983828281 -4.823596631603651e-08 -0.0995764238514374 +2.0259 0.7063583296030944 0.7063573256279465 -4.532911864141504e-08 -0.09957655225354539 +2.026 0.7063585567717854 0.7063575527730657 -4.242262158132338e-08 -0.09957668061681235 +2.0261 0.7063587839028688 0.7063577798182181 -3.9517144326945124e-08 -0.09957680894124997 +2.0262000000000002 0.7063590109963462 0.7063580067634438 -3.6613355635295095e-08 -0.09957693722686993 +2.0263 0.7063592380522122 0.7063582336087904 -3.371192367168478e-08 -0.09957706547368399 +2.0264 0.7063594650704538 0.7063584603543117 -3.0813515859316395e-08 -0.09957719368170376 +2.0265 0.7063596920510513 0.7063586870000695 -2.7918798724919577e-08 -0.09957732185094105 +2.0266 0.7063599189939773 0.7063589135461321 -2.502843774766783e-08 -0.09957744998140744 +2.0267 0.7063601458991978 0.7063591399925752 -2.2143097201752365e-08 -0.09957757807311463 +2.0268 0.7063603727666714 0.7063593663394814 -1.9263440006762195e-08 -0.09957770612607428 +2.0269 0.7063605995963496 0.7063595925869408 -1.6390127577196878e-08 -0.09957783414029804 +2.027 0.7063608263881767 0.7063598187350506 -1.352381966395616e-08 -0.09957796211579761 +2.0271000000000003 0.7063610531420904 0.7063600447839142 -1.066517421252633e-08 -0.09957809005258468 +2.0272 0.7063612798580211 0.7063602707336436 -7.814847204253017e-09 -0.09957821795067093 +2.0273000000000003 0.7063615065358921 0.7063604965843562 -4.9734925075886616e-09 -0.09957834581006798 +2.0274 0.7063617331756196 0.7063607223361767 -2.14176172977365e-09 -0.09957847363078745 +2.0275 0.7063619597771131 0.7063609479892375 6.796959332172614e-10 -0.09957860141284101 +2.0276 0.7063621863402748 0.7063611735436777 3.490233843259083e-09 -0.09957872915624033 +2.0277 0.7063624128650005 0.7063613989996428 6.2892080718648935e-09 -0.09957885686099702 +2.0278 0.7063626393511786 0.7063616243572854 9.075977551974146e-09 -0.09957898452712272 +2.0279000000000003 0.7063628657986913 0.7063618496167654 1.1849904208924289e-08 -0.09957911215462911 +2.028 0.7063630922074133 0.706362074778249 1.4610353123514774e-08 -0.09957923974352781 +2.0281000000000002 0.7063633185772129 0.706362299841909 1.735669266905021e-08 -0.09957936729383045 +2.0282 0.7063635449079515 0.7063625248079257 2.0088294657057137e-08 -0.09957949480554867 +2.0283 0.7063637711994839 0.7063627496764853 2.2804534479531346e-08 -0.09957962227869402 +2.0284 0.706363997451658 0.7063629744477808 2.5504791254654657e-08 -0.09957974971327818 +2.0285 0.7063642236643156 0.7063631991220123 2.818844796297071e-08 -0.09957987710931276 +2.0286 0.7063644498372912 0.7063634236993859 3.085489160177535e-08 -0.09958000446680933 +2.0287 0.7063646759704136 0.7063636481801148 3.350351331088408e-08 -0.09958013178577958 +2.0288000000000004 0.7063649020635046 0.7063638725644181 3.613370850794051e-08 -0.09958025906623512 +2.0289 0.7063651281163792 0.7063640968525218 3.874487704974561e-08 -0.09958038630818747 +2.029 0.7063653541288468 0.7063643210446577 4.133642334501475e-08 -0.09958051351164827 +2.0291 0.7063655801007102 0.7063645451410643 4.390775650356393e-08 -0.09958064067662911 +2.0292 0.7063658060317652 0.7063647691419865 4.645829046467931e-08 -0.09958076780314153 +2.0293 0.7063660319218027 0.706364993047675 4.898744413936451e-08 -0.09958089489119717 +2.0294 0.7063662577706062 0.7063652168583873 5.1494641514424067e-08 -0.0995810219408076 +2.0295 0.7063664835779537 0.7063654405743864 5.3979311834609356e-08 -0.09958114895198442 +2.0296000000000003 0.7063667093436172 0.7063656641959418 5.6440889696293683e-08 -0.09958127592473921 +2.0297 0.7063669350673625 0.706365887723329 5.887881515849458e-08 -0.09958140285908357 +2.0298000000000003 0.7063671607489492 0.7063661111568286 6.129253392501977e-08 -0.09958152975502903 +2.0299 0.7063673863881315 0.7063663344967279 6.368149742426443e-08 -0.09958165661258711 +2.03 0.7063676119846573 0.70636655774332 6.60451629462544e-08 -0.09958178343176943 +2.0301 0.7063678375382691 0.7063667808969034 6.838299378142398e-08 -0.09958191021258754 +2.0302000000000002 0.7063680630487037 0.7063670039577824 7.069445932990359e-08 -0.09958203695505297 +2.0303 0.7063682885156921 0.7063672269262671 7.297903520733784e-08 -0.09958216365917731 +2.0304 0.7063685139389599 0.7063674498026726 7.523620339407178e-08 -0.09958229032497211 +2.0305 0.706368739318227 0.7063676725873205 7.746545233056068e-08 -0.09958241695244889 +2.0306 0.7063689646532083 0.7063678952805369 7.966627703880069e-08 -0.09958254354161929 +2.0307 0.7063691899436129 0.7063681178826533 8.183817924375947e-08 -0.09958267009249472 +2.0308 0.7063694151891448 0.7063683403940069 8.398066747052069e-08 -0.09958279660508679 +2.0309 0.7063696403895027 0.7063685628149395 8.609325717785776e-08 -0.09958292307940701 +2.031 0.7063698655443804 0.7063687851457987 8.817547084497002e-08 -0.0995830495154669 +2.0311000000000003 0.7063700906534668 0.7063690073869364 9.022683808770915e-08 -0.09958317591327799 +2.0312 0.7063703157164453 0.7063692295387101 9.224689577480572e-08 -0.09958330227285181 +2.0313000000000003 0.7063705407329945 0.7063694516014818 9.423518811113585e-08 -0.09958342859419986 +2.0314 0.7063707657027888 0.7063696735756182 9.619126676782552e-08 -0.09958355487733367 +2.0315 0.7063709906254974 0.7063698954614911 9.811469095857839e-08 -0.09958368112226473 +2.0316 0.7063712155007846 0.7063701172594767 1.0000502755416751e-07 -0.09958380732900457 +2.0317 0.7063714403283108 0.706370338969956 1.0186185116917157e-07 -0.0995839334975647 +2.0318 0.7063716651077319 0.7063705605933142 1.0368474427646657e-07 -0.09958405962795669 +2.0319000000000003 0.7063718898386984 0.7063707821299405 1.0547329727314536e-07 -0.09958418572019193 +2.032 0.7063721145208577 0.7063710035802293 1.072271085811316e-07 -0.09958431177428195 +2.0321000000000002 0.7063723391538523 0.7063712249445784 1.0894578476861039e-07 -0.09958443779023826 +2.0322 0.7063725637373208 0.7063714462233901 1.1062894058819217e-07 -0.09958456376807232 +2.0323 0.7063727882708977 0.7063716674170706 1.1227619910181286e-07 -0.0995846897077956 +2.0324 0.7063730127542135 0.7063718885260303 1.138871917397144e-07 -0.09958481560941965 +2.0325 0.706373237186895 0.7063721095506829 1.154615584114671e-07 -0.09958494147295587 +2.0326 0.7063734615685653 0.7063723304914463 1.1699894754760298e-07 -0.09958506729841576 +2.0327 0.7063736858988434 0.706372551348742 1.1849901621410752e-07 -0.09958519308581079 +2.0328000000000004 0.7063739101773452 0.7063727721229951 1.1996143017140026e-07 -0.09958531883515248 +2.0329 0.7063741344036829 0.7063729928146341 1.2138586395066264e-07 -0.09958544454645224 +2.033 0.7063743585774651 0.7063732134240905 1.2277200092322693e-07 -0.09958557021972152 +2.0331 0.7063745826982978 0.7063734339518 1.2411953337690407e-07 -0.09958569585497179 +2.0332 0.7063748067657831 0.7063736543982005 1.2542816258190315e-07 -0.0995858214522146 +2.0333 0.7063750307795201 0.7063738747637338 1.266975988706287e-07 -0.09958594701146127 +2.0334 0.7063752547391053 0.7063740950488439 1.2792756165502794e-07 -0.0995860725327233 +2.0335 0.7063754786441319 0.7063743152539783 1.291177795480214e-07 -0.09958619801601214 +2.0336000000000003 0.7063757024941901 0.7063745353795872 1.3026799038778902e-07 -0.09958632346133922 +2.0337 0.706375926288868 0.706374755426123 1.3137794130715919e-07 -0.09958644886871593 +2.0338000000000003 0.706376150027751 0.7063749753940414 1.3244738879258922e-07 -0.09958657423815376 +2.0339 0.7063763737104216 0.7063751952838003 1.33476098711921e-07 -0.09958669956966412 +2.034 0.70637659733646 0.7063754150958599 1.3446384639070885e-07 -0.09958682486325843 +2.0341 0.7063768209054443 0.7063756348306826 1.3541041666773057e-07 -0.09958695011894814 +2.0342000000000002 0.7063770444169504 0.7063758544887331 1.36315603929682e-07 -0.09958707533674463 +2.0343 0.7063772678705518 0.7063760740704785 1.3717921213546314e-07 -0.09958720051665934 +2.0344 0.7063774912658206 0.7063762935763873 1.3800105488903647e-07 -0.09958732565870368 +2.0345 0.7063777146023262 0.7063765130069304 1.387809554671826e-07 -0.09958745076288905 +2.0346 0.7063779378796369 0.70637673236258 1.3951874686113364e-07 -0.09958757582922684 +2.0347 0.706378161097319 0.7063769516438105 1.4021427179738977e-07 -0.0995877008577285 +2.0348 0.7063783842549374 0.7063771708510975 1.408673828071083e-07 -0.09958782584840539 +2.0349 0.7063786073520552 0.706377389984918 1.4147794221222587e-07 -0.0995879508012689 +2.035 0.7063788303882346 0.7063776090457504 1.4204582217750006e-07 -0.09958807571633048 +2.0351000000000004 0.7063790533630364 0.7063778280340748 1.425709047486734e-07 -0.0995882005936015 +2.0352 0.7063792762760203 0.7063780469503718 1.4305308184553445e-07 -0.09958832543309336 +2.0353000000000003 0.7063794991267441 0.7063782657951232 1.4349225531742893e-07 -0.09958845023481736 +2.0354 0.7063797219147663 0.7063784845688119 1.4388833692591252e-07 -0.09958857499878497 +2.0355 0.706379944639643 0.7063787032719215 1.4424124839332308e-07 -0.09958869972500752 +2.0356 0.7063801673009305 0.7063789219049366 1.4455092141665848e-07 -0.09958882441349637 +2.0357 0.7063803898981842 0.7063791404683417 1.4481729765022933e-07 -0.09958894906426292 +2.0358 0.7063806124309587 0.7063793589626224 1.450403287438229e-07 -0.09958907367731852 +2.0359000000000003 0.7063808348988089 0.7063795773882646 1.4521997636005035e-07 -0.0995891982526745 +2.036 0.7063810573012888 0.7063797957457545 1.4535621214659122e-07 -0.09958932279034226 +2.0361000000000002 0.7063812796379526 0.7063800140355782 1.4544901776394892e-07 -0.09958944729033316 +2.0362 0.7063815019083541 0.706380232258222 1.4549838487851185e-07 -0.0995895717526585 +2.0363 0.7063817241120471 0.7063804504141725 1.4550431515561457e-07 -0.09958969617732966 +2.0364 0.7063819462485861 0.7063806685039158 1.454668202734155e-07 -0.099589820564358 +2.0365 0.7063821683175253 0.7063808865279373 1.4538592190208033e-07 -0.09958994491375484 +2.0366 0.7063823903184194 0.7063811044867232 1.4526165169337357e-07 -0.09959006922553154 +2.0367 0.7063826122508234 0.7063813223807583 1.450940512980059e-07 -0.09959019349969939 +2.0368000000000004 0.7063828341142934 0.7063815402105273 1.4488317232400072e-07 -0.09959031773626978 +2.0369 0.7063830559083853 0.7063817579765137 1.4462907630893862e-07 -0.09959044193525399 +2.037 0.7063832776326568 0.7063819756792007 1.4433183475812128e-07 -0.09959056609666335 +2.0371 0.7063834992866656 0.7063821933190706 1.439915290578353e-07 -0.09959069022050923 +2.0372 0.7063837208699706 0.7063824108966044 1.4360825053780224e-07 -0.0995908143068029 +2.0373 0.7063839423821321 0.7063826284122822 1.431821003358702e-07 -0.09959093835555569 +2.0374 0.7063841638227117 0.7063828458665825 1.4271318946740275e-07 -0.09959106236677889 +2.0375 0.7063843851912718 0.7063830632599831 1.4220163875588998e-07 -0.09959118634048382 +2.0376000000000003 0.7063846064873764 0.7063832805929601 1.4164757881213186e-07 -0.09959131027668179 +2.0377 0.7063848277105915 0.7063834978659878 1.4105114999260482e-07 -0.09959143417538413 +2.0378000000000003 0.7063850488604837 0.7063837150795396 1.4041250236129788e-07 -0.09959155803660212 +2.0379 0.7063852699366222 0.7063839322340859 1.3973179567930427e-07 -0.09959168186034699 +2.038 0.7063854909385778 0.7063841493300969 1.390091993319631e-07 -0.09959180564663012 +2.0381 0.7063857118659234 0.7063843663680394 1.382448922941648e-07 -0.09959192939546278 +2.0382000000000002 0.706385932718233 0.7063845833483791 1.3743906310259568e-07 -0.0995920531068562 +2.0383 0.706386153495084 0.7063848002715787 1.3659190981063496e-07 -0.0995921767808217 +2.0384 0.7063863741960555 0.7063850171380996 1.3570363990508816e-07 -0.09959230041737056 +2.0385 0.7063865948207286 0.7063852339484005 1.3477447029924816e-07 -0.09959242401651404 +2.0386 0.7063868153686874 0.7063854507029371 1.3380462725309794e-07 -0.09959254757826341 +2.0387 0.7063870358395183 0.7063856674021634 1.327943463247383e-07 -0.09959267110262995 +2.0388 0.7063872562328102 0.70638588404653 1.3174387231834617e-07 -0.09959279458962492 +2.0389 0.7063874765481548 0.7063861006364854 1.3065345920784677e-07 -0.09959291803925956 +2.039 0.7063876967851468 0.7063863171724751 1.2952337010221915e-07 -0.09959304145154513 +2.0391000000000004 0.7063879169433838 0.7063865336549412 1.2835387717610725e-07 -0.09959316482649291 +2.0392 0.7063881370224663 0.7063867500843233 1.2714526155879757e-07 -0.09959328816411417 +2.0393000000000003 0.7063883570219979 0.7063869664610574 1.258978133619748e-07 -0.09959341146442009 +2.0394 0.7063885769415855 0.7063871827855767 1.2461183151318833e-07 -0.09959353472742194 +2.0395 0.7063887967808394 0.706387399058311 1.2328762374197444e-07 -0.09959365795313102 +2.0396 0.7063890165393732 0.7063876152796863 1.219255064723035e-07 -0.09959378114155845 +2.0397 0.7063892362168038 0.7063878314501256 1.205258047705382e-07 -0.09959390429271553 +2.0398 0.7063894558127521 0.7063880475700482 1.1908885226563637e-07 -0.09959402740661351 +2.0399000000000003 0.7063896753268425 0.7063882636398693 1.1761499106588413e-07 -0.0995941504832636 +2.04 0.7063898947587031 0.706388479660001 1.1610457167909871e-07 -0.09959427352267704 +2.0401000000000002 0.7063901141079658 0.7063886956308507 1.1455795291895332e-07 -0.09959439652486501 +2.0402 0.7063903333742663 0.7063889115528226 1.129755018321188e-07 -0.09959451948983875 +2.0403000000000002 0.7063905525572451 0.7063891274263161 1.1135759361152742e-07 -0.09959464241760946 +2.0404 0.706390771656546 0.7063893432517274 1.097046114922895e-07 -0.09959476530818837 +2.0405 0.7063909906718173 0.7063895590294479 1.0801694668924333e-07 -0.09959488816158667 +2.0406 0.7063912096027114 0.7063897747598644 1.0629499827205513e-07 -0.09959501097781553 +2.0407 0.7063914284488857 0.7063899904433601 1.0453917307848282e-07 -0.09959513375688621 +2.0408000000000004 0.7063916472100016 0.7063902060803132 1.02749885651926e-07 -0.0995952564988099 +2.0409 0.7063918658857247 0.7063904216710973 1.0092755809570919e-07 -0.09959537920359778 +2.041 0.7063920844757257 0.7063906372160818 9.907262000716233e-08 -0.099595501871261 +2.0411 0.7063923029796799 0.7063908527156311 9.7185508363129e-08 -0.09959562450181081 +2.0412 0.7063925213972673 0.7063910681701047 9.526666742629142e-08 -0.09959574709525833 +2.0413 0.7063927397281731 0.7063912835798575 9.331654861333138e-08 -0.09959586965161482 +2.0414 0.7063929579720867 0.7063914989452396 9.133561042554139e-08 -0.09959599217089142 +2.0415 0.7063931761287031 0.7063917142665956 8.932431832392451e-08 -0.09959611465309931 +2.0416000000000003 0.7063933941977221 0.706391929544265 8.728314460776376e-08 -0.09959623709824958 +2.0417 0.7063936121788488 0.7063921447785826 8.521256833135538e-08 -0.09959635950635344 +2.0418000000000003 0.7063938300717933 0.7063923599698778 8.311307517043509e-08 -0.09959648187742208 +2.0419 0.7063940478762714 0.706392575118475 8.098515730595168e-08 -0.09959660421146665 +2.042 0.7063942655920038 0.7063927902246927 7.882931333386134e-08 -0.09959672650849834 +2.0421 0.7063944832187171 0.7063930052888439 7.664604811941089e-08 -0.09959684876852826 +2.0422000000000002 0.7063947007561429 0.7063932203112364 7.44358726999933e-08 -0.09959697099156754 +2.0423 0.7063949182040183 0.7063934352921728 7.219930415677811e-08 -0.09959709317762738 +2.0424 0.706395135562087 0.7063936502319496 6.99368654846072e-08 -0.09959721532671893 +2.0425 0.7063953528300972 0.7063938651308572 6.764908549138082e-08 -0.0995973374388533 +2.0426 0.7063955700078033 0.7063940799891812 6.533649865234081e-08 -0.09959745951404161 +2.0427 0.7063957870949653 0.7063942948072011 6.299964500425248e-08 -0.09959758155229502 +2.0428 0.7063960040913496 0.7063945095851898 6.063907000142255e-08 -0.09959770355362464 +2.0429 0.7063962209967283 0.7063947243234152 5.8255324409881015e-08 -0.09959782551804165 +2.043 0.7063964378108789 0.7063949390221387 5.584896415472551e-08 -0.09959794744555711 +2.0431 0.7063966545335856 0.7063951536816158 5.342055021256842e-08 -0.09959806933618216 +2.0432 0.7063968711646385 0.7063953683020961 5.097064846061594e-08 -0.09959819118992795 +2.0433000000000003 0.7063970877038335 0.7063955828838226 4.849982956391108e-08 -0.09959831300680552 +2.0434 0.7063973041509731 0.7063957974270327 4.60086688330863e-08 -0.09959843478682603 +2.0435 0.7063975205058659 0.7063960119319571 4.349774608385093e-08 -0.09959855653000058 +2.0436 0.7063977367683265 0.7063962263988203 4.096764551382581e-08 -0.09959867823634022 +2.0437 0.7063979529381761 0.7063964408278406 3.841895556029595e-08 -0.09959879990585609 +2.0438 0.7063981690152425 0.70639665521923 3.585226877010628e-08 -0.09959892153855932 +2.0439000000000003 0.7063983849993593 0.7063968695731939 3.32681816574143e-08 -0.09959904313446093 +2.044 0.7063986008903669 0.7063970838899314 3.0667294557973346e-08 -0.09959916469357208 +2.0441000000000003 0.7063988166881123 0.7063972981696349 2.8050211502497757e-08 -0.09959928621590386 +2.0442 0.706399032392449 0.7063975124124905 2.541754006747665e-08 -0.0995994077014673 +2.0443000000000002 0.7063992480032365 0.7063977266186775 2.2769891241600226e-08 -0.09959952915027351 +2.0444 0.7063994635203417 0.7063979407883689 2.010787926789992e-08 -0.09959965056233361 +2.0445 0.7063996789436373 0.7063981549217309 1.743212152925666e-08 -0.0995997719376586 +2.0446 0.7063998942730034 0.7063983690189226 1.4743238380132695e-08 -0.09959989327625957 +2.0447 0.7064001095083265 0.706398583080097 1.2041853012997872e-08 -0.09960001457814761 +2.0448000000000004 0.7064003246494998 0.7063987971054004 9.3285913143476e-09 -0.09960013584333377 +2.0449 0.706400539696423 0.706399011094972 6.6040817163839916e-09 -0.09960025707182912 +2.045 0.7064007546490028 0.7063992250489441 3.868955051299083e-09 -0.09960037826364465 +2.0451 0.7064009695071529 0.7063994389674428 1.123844412496966e-09 -0.0996004994187915 +2.0452 0.7064011842707933 0.7063996528505867 -1.6306149989292473e-09 -0.09960062053728062 +2.0453 0.7064013989398515 0.7063998666984883 -4.393786020781554e-09 -0.09960074161912319 +2.0454 0.7064016135142615 0.7064000805112527 -7.1650296737391095e-09 -0.09960086266433016 +2.0455 0.7064018279939639 0.7064002942889778 -9.943705313146534e-09 -0.09960098367291263 +2.0456000000000003 0.7064020423789068 0.7064005080317552 -1.272917076996019e-08 -0.09960110464488157 +2.0457 0.7064022566690445 0.7064007217396698 -1.552078250947539e-08 -0.0996012255802481 +2.0458000000000003 0.7064024708643388 0.7064009354127988 -1.83178957714053e-08 -0.09960134647902318 +2.0459 0.7064026849647583 0.706401149051213 -2.1119864721235587e-08 -0.09960146734121787 +2.046 0.7064028989702784 0.706401362654976 -2.3926042604181103e-08 -0.0996015881668432 +2.0461 0.7064031128808814 0.7064015762241445 -2.6735781883530096e-08 -0.09960170895591018 +2.0462000000000002 0.7064033266965564 0.706401789758768 -2.9548434401756654e-08 -0.09960182970842973 +2.0463 0.7064035404173 0.7064020032588897 -3.236335152125014e-08 -0.09960195042441301 +2.0464 0.7064037540431154 0.7064022167245454 -3.517988427957294e-08 -0.09960207110387098 +2.0465 0.706403967574013 0.7064024301557639 -3.799738353463516e-08 -0.09960219174681466 +2.0466 0.7064041810100097 0.706402643552567 -4.0815200118163395e-08 -0.09960231235325501 +2.0467 0.7064043943511298 0.7064028569149698 -4.363268498252886e-08 -0.09960243292320309 +2.0468 0.7064046075974042 0.70640307024298 -4.644918935155988e-08 -0.09960255345666984 +2.0469 0.7064048207488713 0.7064032835365988 -4.926406486937575e-08 -0.09960267395366627 +2.047 0.7064050338055758 0.7064034967958199 -5.207666374897665e-08 -0.09960279441420342 +2.0471 0.7064052467675699 0.7064037100206308 -5.4886338921294325e-08 -0.09960291483829224 +2.0472 0.7064054596349117 0.7064039232110113 -5.769244418719725e-08 -0.09960303522594365 +2.0473000000000003 0.7064056724076677 0.7064041363669347 -6.049433436084925e-08 -0.09960315557716867 +2.0474 0.7064058850859104 0.7064043494883671 -6.329136542073885e-08 -0.0996032758919783 +2.0475 0.7064060976697195 0.7064045625752682 -6.60828946598413e-08 -0.09960339617038355 +2.0476 0.7064063101591814 0.7064047756275903 -6.88682808285164e-08 -0.09960351641239534 +2.0477 0.7064065225543894 0.7064049886452792 -7.164688428391158e-08 -0.09960363661802468 +2.0478 0.7064067348554437 0.7064052016282736 -7.44180671395818e-08 -0.09960375678728253 +2.0479000000000003 0.7064069470624509 0.7064054145765055 -7.718119340860419e-08 -0.09960387692017979 +2.048 0.706407159175525 0.7064056274899 -7.993562914799385e-08 -0.09960399701672747 +2.0481 0.7064073711947865 0.7064058403683751 -8.268074260745634e-08 -0.09960411707693646 +2.0482000000000005 0.7064075831203627 0.7064060532118428 -8.541590437293606e-08 -0.09960423710081776 +2.0483000000000002 0.7064077949523875 0.7064062660202081 -8.814048751450143e-08 -0.09960435708838235 +2.0484 0.7064080066910017 0.7064064787933688 -9.085386772252069e-08 -0.0996044770396411 +2.0485 0.7064082183363525 0.7064066915312167 -9.355542345251128e-08 -0.09960459695460504 +2.0486 0.706408429888594 0.7064069042336365 -9.624453607779554e-08 -0.09960471683328503 +2.0487 0.7064086413478868 0.7064071169005065 -9.892059001266607e-08 -0.09960483667569209 +2.0488000000000004 0.7064088527143979 0.7064073295316986 -1.015829728711129e-07 -0.09960495648183709 +2.0489 0.7064090639883011 0.7064075421270777 -1.0423107559345834e-07 -0.09960507625173098 +2.049 0.7064092751697761 0.7064077546865022 -1.0686429259641056e-07 -0.09960519598538461 +2.0490999999999997 0.70640948625901 0.7064079672098246 -1.0948202190490253e-07 -0.099605315682809 +2.0492000000000004 0.7064096972561957 0.7064081796968908 -1.1208366529694147e-07 -0.09960543534401509 +2.0493 0.7064099081615324 0.70640839214754 -1.1466862842243741e-07 -0.09960555496901372 +2.0494 0.7064101189752259 0.7064086045616054 -1.1723632095499148e-07 -0.09960567455781583 +2.0495 0.7064103296974882 0.7064088169389133 -1.1978615673154114e-07 -0.09960579411043233 +2.0496 0.7064105403285375 0.706409029279285 -1.2231755386685195e-07 -0.09960591362687415 +2.0497 0.7064107508685977 0.7064092415825339 -1.2482993490096905e-07 -0.09960603310715213 +2.0498000000000003 0.7064109613178997 0.7064094538484689 -1.273227269327909e-07 -0.09960615255127715 +2.0499 0.7064111716766803 0.7064096660768915 -1.2979536173109152e-07 -0.0996062719592602 +2.05 0.7064113819451823 0.706409878267598 -1.3224727588891094e-07 -0.09960639133111214 +2.0501 0.7064115921236537 0.7064100904203787 -1.346779109363122e-07 -0.09960651066684388 +2.0502000000000002 0.7064118022123493 0.7064103025350175 -1.3708671346701617e-07 -0.09960662996646627 +2.0503 0.7064120122115296 0.7064105146112925 -1.3947313528064886e-07 -0.0996067492299902 +2.0504000000000002 0.7064122221214606 0.7064107266489761 -1.418366334833554e-07 -0.09960686845742653 +2.0505 0.7064124319424144 0.7064109386478348 -1.4417667062831263e-07 -0.09960698764878612 +2.0505999999999998 0.7064126416746687 0.7064111506076298 -1.4649271483542503e-07 -0.09960710680407986 +2.0507000000000004 0.7064128513185068 0.7064113625281163 -1.4878423990581646e-07 -0.0996072259233187 +2.0508 0.7064130608742176 0.7064115744090442 -1.510507254501997e-07 -0.09960734500651344 +2.0509 0.7064132703420957 0.7064117862501573 -1.5329165699816405e-07 -0.09960746405367497 +2.051 0.7064134797224405 0.7064119980511948 -1.5550652611613647e-07 -0.09960758306481414 +2.0511 0.7064136890155571 0.7064122098118893 -1.5769483053575117e-07 -0.09960770203994171 +2.0512 0.7064138982217565 0.7064124215319694 -1.598560742492594e-07 -0.09960782097906863 +2.0513000000000003 0.7064141073413541 0.7064126332111577 -1.619897676326948e-07 -0.09960793988220576 +2.0514 0.7064143163746708 0.7064128448491718 -1.6409542755689566e-07 -0.0996080587493639 +2.0515 0.7064145253220329 0.7064130564457242 -1.6617257748638425e-07 -0.09960817758055396 +2.0516 0.7064147341837712 0.7064132680005224 -1.6822074759732797e-07 -0.09960829637578673 +2.0517000000000003 0.7064149429602217 0.7064134795132688 -1.7023947488162272e-07 -0.09960841513507307 +2.0518 0.7064151516517252 0.7064136909836611 -1.7222830325444582e-07 -0.09960853385842378 +2.0519000000000003 0.7064153602586277 0.706413902411392 -1.7418678364966578e-07 -0.09960865254584972 +2.052 0.7064155687812793 0.7064141137961496 -1.7611447412912984e-07 -0.09960877119736172 +2.0521 0.706415777220035 0.706414325137617 -1.7801093997807382e-07 -0.09960888981297059 +2.0522000000000005 0.7064159855752548 0.7064145364354735 -1.7987575380573606e-07 -0.09960900839268717 +2.0523000000000002 0.7064161938473027 0.7064147476893932 -1.8170849561474633e-07 -0.09960912693652234 +2.0524 0.7064164020365467 0.7064149588990454 -1.835087529503121e-07 -0.09960924544448674 +2.0525 0.70641661014336 0.7064151700640964 -1.8527612096960744e-07 -0.09960936391659131 +2.0526 0.7064168181681197 0.7064153811842071 -1.8701020249381473e-07 -0.09960948235284682 +2.0527 0.7064170261112073 0.7064155922590347 -1.887106081573109e-07 -0.09960960075326411 +2.0528000000000004 0.7064172339730076 0.7064158032882323 -1.903769564388924e-07 -0.09960971911785398 +2.0529 0.7064174417539102 0.7064160142714488 -1.920088738074921e-07 -0.09960983744662719 +2.053 0.7064176494543082 0.7064162252083293 -1.9360599474993467e-07 -0.09960995573959454 +2.0530999999999997 0.7064178570745987 0.7064164360985152 -1.951679618854285e-07 -0.09961007399676686 +2.0532000000000004 0.7064180646151825 0.7064166469416442 -1.9669442604536291e-07 -0.0996101922181549 +2.0533 0.7064182720764641 0.7064168577373497 -1.9818504633922762e-07 -0.09961031040376953 +2.0534 0.7064184794588513 0.7064170684852624 -1.996394902205323e-07 -0.0996104285536214 +2.0535 0.7064186867627551 0.7064172791850087 -2.01057433583951e-07 -0.09961054666772129 +2.0536 0.7064188939885907 0.7064174898362124 -2.0243856081389455e-07 -0.09961066474608005 +2.0537 0.7064191011367764 0.7064177004384937 -2.0378256490594104e-07 -0.09961078278870845 +2.0538000000000003 0.7064193082077329 0.7064179109914694 -2.050891474494887e-07 -0.09961090079561725 +2.0539 0.7064195152018851 0.7064181214947538 -2.0635801878735038e-07 -0.09961101876681722 +2.054 0.7064197221196599 0.7064183319479573 -2.0758889800187585e-07 -0.09961113670231914 +2.0541 0.7064199289614876 0.7064185423506881 -2.0878151302250458e-07 -0.09961125460213371 +2.0542000000000002 0.7064201357278013 0.7064187527025514 -2.0993560068127692e-07 -0.09961137246627175 +2.0543 0.7064203424190366 0.7064189630031497 -2.1105090673018134e-07 -0.09961149029474398 +2.0544000000000002 0.706420549035632 0.7064191732520826 -2.121271859729934e-07 -0.09961160808756114 +2.0545 0.7064207555780284 0.7064193834489478 -2.1316420225139798e-07 -0.0996117258447341 +2.0545999999999998 0.7064209620466688 0.7064195935933396 -2.141617285213171e-07 -0.09961184356627344 +2.0547000000000004 0.7064211684419989 0.7064198036848507 -2.1511954690842106e-07 -0.0996119612521899 +2.0548 0.7064213747644666 0.7064200137230716 -2.1603744874282294e-07 -0.09961207890249435 +2.0549 0.7064215810145218 0.7064202237075905 -2.1691523461458972e-07 -0.09961219651719744 +2.055 0.7064217871926166 0.7064204336379933 -2.1775271441190625e-07 -0.09961231409630994 +2.0551 0.7064219932992046 0.7064206435138642 -2.1854970736617796e-07 -0.09961243163984254 +2.0552 0.7064221993347415 0.7064208533347858 -2.193060420763171e-07 -0.09961254914780594 +2.0553000000000003 0.706422405299685 0.7064210631003384 -2.200215565711927e-07 -0.09961266662021091 +2.0554 0.706422611194494 0.7064212728101014 -2.206960983269779e-07 -0.0996127840570682 +2.0555 0.7064228170196287 0.7064214824636521 -2.2132952430184427e-07 -0.09961290145838846 +2.0556 0.7064230227755515 0.7064216920605664 -2.2192170096371755e-07 -0.09961301882418239 +2.0557000000000003 0.7064232284627252 0.7064219016004193 -2.2247250431456367e-07 -0.09961313615446071 +2.0558 0.7064234340816147 0.7064221110827844 -2.229818199354916e-07 -0.09961325344923418 +2.0559000000000003 0.7064236396326853 0.7064223205072337 -2.2344954298675335e-07 -0.09961337070851344 +2.056 0.706423845116404 0.7064225298733393 -2.2387557824937732e-07 -0.09961348793230927 +2.0561 0.7064240505332375 0.706422739180671 -2.2425984012863776e-07 -0.09961360512063226 +2.0562000000000005 0.7064242558836547 0.7064229484287988 -2.246022526575242e-07 -0.09961372227349319 +2.0563000000000002 0.7064244611681243 0.7064231576172917 -2.2490274957306933e-07 -0.09961383939090267 +2.0564 0.7064246663871161 0.706423366745718 -2.2516127425736832e-07 -0.09961395647287148 +2.0565 0.7064248715411 0.7064235758136459 -2.2537777978615114e-07 -0.09961407351941028 +2.0566 0.706425076630546 0.7064237848206424 -2.2555222891143534e-07 -0.09961419053052967 +2.0567 0.7064252816559252 0.7064239937662751 -2.2568459410315933e-07 -0.0996143075062404 +2.0568 0.7064254866177084 0.7064242026501111 -2.25774857514488e-07 -0.09961442444655315 +2.0569 0.7064256915163667 0.706424411471717 -2.258230110199766e-07 -0.09961454135147861 +2.057 0.7064258963523704 0.70642462023066 -2.2582905617740678e-07 -0.09961465822102734 +2.0570999999999997 0.7064261011261908 0.706424828926507 -2.2579300425554227e-07 -0.09961477505521008 +2.0572000000000004 0.7064263058382979 0.7064250375588259 -2.2571487620290376e-07 -0.09961489185403752 +2.0573 0.706426510489162 0.7064252461271838 -2.2559470267205506e-07 -0.0996150086175202 +2.0574 0.7064267150792531 0.7064254546311493 -2.2543252397103086e-07 -0.09961512534566891 +2.0575 0.7064269196090398 0.7064256630702904 -2.252283900772145e-07 -0.09961524203849417 +2.0576 0.7064271240789909 0.706425871444177 -2.2498236061999077e-07 -0.09961535869600673 +2.0577 0.7064273284895738 0.7064260797523794 -2.246945048564597e-07 -0.0996154753182172 +2.0578000000000003 0.7064275328412559 0.706426287994468 -2.243649016610283e-07 -0.09961559190513626 +2.0579 0.7064277371345027 0.7064264961700151 -2.239936394733688e-07 -0.09961570845677453 +2.058 0.7064279413697786 0.7064267042785931 -2.23580816346991e-07 -0.09961582497314253 +2.0581 0.7064281455475476 0.706426912319777 -2.2312653984515873e-07 -0.09961594145425107 +2.0582000000000003 0.7064283496682723 0.7064271202931414 -2.2263092705129828e-07 -0.09961605790011067 +2.0583 0.7064285537324131 0.7064273281982636 -2.220941045412428e-07 -0.09961617431073201 +2.0584000000000002 0.7064287577404298 0.7064275360347214 -2.215162083485378e-07 -0.09961629068612565 +2.0585 0.7064289616927802 0.7064277438020947 -2.2089738391239955e-07 -0.09961640702630226 +2.0585999999999998 0.7064291655899206 0.7064279514999654 -2.2023778607077604e-07 -0.09961652333127247 +2.0587000000000004 0.7064293694323055 0.7064281591279162 -2.195375789944276e-07 -0.09961663960104687 +2.0588 0.7064295732203871 0.7064283666855324 -2.1879693615570184e-07 -0.09961675583563603 +2.0589 0.7064297769546162 0.7064285741724012 -2.180160402973086e-07 -0.09961687203505062 +2.059 0.7064299806354412 0.7064287815881116 -2.1719508338027826e-07 -0.0996169881993012 +2.0591 0.7064301842633084 0.7064289889322551 -2.1633426652845067e-07 -0.0996171043283984 +2.0592 0.7064303878386619 0.7064291962044251 -2.1543379997990275e-07 -0.09961722042235277 +2.0593000000000004 0.7064305913619431 0.7064294034042177 -2.1449390305225413e-07 -0.09961733648117496 +2.0594 0.7064307948335914 0.7064296105312311 -2.135148040836865e-07 -0.09961745250487553 +2.0595 0.7064309982540434 0.7064298175850666 -2.1249674035314636e-07 -0.09961756849346508 +2.0596 0.7064312016237331 0.7064300245653274 -2.1143995806993665e-07 -0.09961768444695418 +2.0597000000000003 0.7064314049430915 0.7064302314716202 -2.1034471226269447e-07 -0.0996178003653534 +2.0598 0.7064316082125472 0.706430438303554 -2.0921126674122714e-07 -0.09961791624867336 +2.0599000000000003 0.7064318114325254 0.7064306450607412 -2.0803989406181778e-07 -0.09961803209692464 +2.06 0.7064320146034483 0.7064308517427969 -2.0683087541273348e-07 -0.09961814791011775 +2.0601 0.7064322177257354 0.706431058349339 -2.0558450056565314e-07 -0.09961826368826329 +2.0602000000000005 0.7064324207998027 0.7064312648799895 -2.0430106782709512e-07 -0.09961837943137188 +2.0603000000000002 0.706432623826063 0.7064314713343732 -2.0298088393780334e-07 -0.09961849513945403 +2.0604 0.706432826804925 0.7064316777121178 -2.016242640172361e-07 -0.09961861081252027 +2.0605 0.7064330297367951 0.7064318840128554 -2.0023153147682993e-07 -0.09961872645058119 +2.0606 0.7064332326220752 0.706432090236221 -1.9880301795061062e-07 -0.09961884205364738 +2.0607 0.7064334354611641 0.7064322963818535 -1.9733906320845707e-07 -0.0996189576217293 +2.0608 0.7064336382544565 0.7064325024493954 -1.9584001509712068e-07 -0.09961907315483755 +2.0609 0.7064338410023433 0.7064327084384936 -1.943062294257336e-07 -0.0996191886529827 +2.061 0.7064340437052115 0.706432914348798 -1.9273806991029763e-07 -0.09961930411617521 +2.0610999999999997 0.7064342463634443 0.7064331201799632 -1.9113590805919234e-07 -0.09961941954442571 +2.0612000000000004 0.7064344489774204 0.7064333259316473 -1.8950012311419462e-07 -0.09961953493774461 +2.0613 0.7064346515475148 0.7064335316035135 -1.8783110193598684e-07 -0.09961965029614259 +2.0614 0.7064348540740983 0.7064337371952283 -1.8612923894170685e-07 -0.09961976561963012 +2.0615 0.7064350565575367 0.7064339427064628 -1.8439493597310896e-07 -0.0996198809082177 +2.0616 0.7064352589981917 0.7064341481368924 -1.8262860223758337e-07 -0.09961999616191583 +2.0617 0.7064354613964211 0.7064343534861974 -1.8083065420407274e-07 -0.09962011138073508 +2.0618000000000003 0.7064356637525773 0.7064345587540624 -1.79001515485111e-07 -0.09962022656468597 +2.0619 0.706435866067008 0.7064347639401766 -1.7714161675008722e-07 -0.09962034171377898 +2.062 0.7064360683400575 0.7064349690442338 -1.7525139563157044e-07 -0.09962045682802466 +2.0621 0.7064362705720639 0.7064351740659326 -1.7333129659694024e-07 -0.09962057190743345 +2.0622000000000003 0.7064364727633607 0.7064353790049767 -1.7138177089461026e-07 -0.09962068695201591 +2.0623 0.706436674914277 0.7064355838610745 -1.6940327638055586e-07 -0.09962080196178248 +2.0624000000000002 0.7064368770251366 0.7064357886339392 -1.6739627747147656e-07 -0.09962091693674367 +2.0625 0.706437079096258 0.7064359933232898 -1.6536124499907934e-07 -0.09962103187691 +2.0625999999999998 0.7064372811279551 0.7064361979288494 -1.632986561094646e-07 -0.09962114678229196 +2.0627000000000004 0.7064374831205363 0.7064364024503471 -1.6120899415557333e-07 -0.09962126165290004 +2.0628 0.7064376850743046 0.7064366068875172 -1.5909274857922595e-07 -0.09962137648874471 +2.0629 0.706437886989558 0.7064368112400987 -1.569504148018347e-07 -0.0996214912898365 +2.063 0.7064380888665887 0.7064370155078366 -1.5478249409603406e-07 -0.09962160605618575 +2.0631 0.7064382907056836 0.7064372196904809 -1.5258949349027107e-07 -0.09962172078780311 +2.0632 0.7064384925071243 0.7064374237877877 -1.5037192563002733e-07 -0.09962183548469895 +2.0633000000000004 0.7064386942711867 0.7064376277995184 -1.4813030866506205e-07 -0.0996219501468838 +2.0634 0.7064388959981407 0.7064378317254392 -1.4586516612971612e-07 -0.09962206477436804 +2.0635 0.7064390976882511 0.706438035565323 -1.4357702682321616e-07 -0.09962217936716217 +2.0636 0.7064392993417765 0.7064382393189486 -1.4126642468650918e-07 -0.09962229392527665 +2.0637000000000003 0.7064395009589698 0.7064384429860995 -1.3893389865654582e-07 -0.09962240844872189 +2.0638 0.7064397025400784 0.7064386465665657 -1.3657999258301357e-07 -0.09962252293750837 +2.0639000000000003 0.7064399040853433 0.7064388500601437 -1.3420525505833392e-07 -0.0996226373916466 +2.064 0.7064401055950003 0.7064390534666345 -1.318102393101095e-07 -0.09962275181114696 +2.0641 0.706440307069278 0.7064392567858465 -1.2939550307448922e-07 -0.09962286619601991 +2.0642000000000005 0.7064405085084 0.7064394600175934 -1.2696160846953353e-07 -0.09962298054627597 +2.0643000000000002 0.7064407099125836 0.7064396631616949 -1.2450912183908924e-07 -0.09962309486192547 +2.0644 0.7064409112820393 0.7064398662179769 -1.2203861365391033e-07 -0.09962320914297886 +2.0645 0.7064411126169723 0.706440069186272 -1.1955065836594114e-07 -0.09962332338944657 +2.0646 0.7064413139175814 0.7064402720664182 -1.170458342678038e-07 -0.09962343760133908 +2.0647 0.7064415151840584 0.7064404748582602 -1.1452472336616337e-07 -0.09962355177866675 +2.0648 0.7064417164165899 0.7064406775616492 -1.119879112394806e-07 -0.09962366592144006 +2.0649 0.7064419176153554 0.7064408801764421 -1.0943598691658118e-07 -0.09962378002966937 +2.065 0.7064421187805279 0.7064410827025027 -1.0686954271532656e-07 -0.0996238941033651 +2.0650999999999997 0.7064423199122749 0.7064412851397008 -1.0428917413592836e-07 -0.09962400814253769 +2.0652000000000004 0.7064425210107568 0.7064414874879132 -1.0169547970222126e-07 -0.09962412214719756 +2.0653 0.7064427220761273 0.7064416897470223 -9.908906082028296e-08 -0.09962423611735505 +2.0654 0.7064429231085346 0.7064418919169175 -9.647052165526887e-08 -0.09962435005302062 +2.0655 0.7064431241081193 0.7064420939974954 -9.384046897788906e-08 -0.0996244639542047 +2.0656 0.7064433250750162 0.7064422959886576 -9.119951203256926e-08 -0.09962457782091766 +2.0657 0.7064435260093527 0.7064424978903133 -8.85482623926015e-08 -0.09962469165316984 +2.0658000000000003 0.7064437269112506 0.7064426997023783 -8.588733381442726e-08 -0.09962480545097169 +2.0659 0.7064439277808243 0.7064429014247745 -8.321734210579856e-08 -0.09962491921433361 +2.066 0.7064441286181822 0.7064431030574305 -8.053890496618338e-08 -0.09962503294326588 +2.0661 0.7064443294234253 0.706443304600282 -7.785264186967178e-08 -0.09962514663777897 +2.0662000000000003 0.7064445301966485 0.7064435060532712 -7.515917390017723e-08 -0.09962526029788324 +2.0663 0.70644473093794 0.7064437074163464 -7.245912360962295e-08 -0.09962537392358904 +2.0664000000000002 0.7064449316473808 0.7064439086894636 -6.975311488653657e-08 -0.09962548751490674 +2.0665 0.7064451323250458 0.7064441098725847 -6.704177280209347e-08 -0.09962560107184676 +2.0665999999999998 0.706445332971003 0.7064443109656784 -6.43257234665684e-08 -0.09962571459441939 +2.0667000000000004 0.7064455335853133 0.7064445119687206 -6.160559389099124e-08 -0.09962582808263505 +2.0668 0.706445734168031 0.706444712881694 -5.8882011834925085e-08 -0.09962594153650413 +2.0669 0.7064459347192041 0.7064449137045872 -5.615560566378519e-08 -0.09962605495603692 +2.067 0.7064461352388733 0.706445114437396 -5.3427004209193746e-08 -0.09962616834124377 +2.0671 0.7064463357270732 0.7064453150801232 -5.069683661567369e-08 -0.09962628169213511 +2.0672 0.7064465361838306 0.706445515632778 -4.7965732202955025e-08 -0.0996263950087212 +2.0673000000000004 0.7064467366091665 0.7064457160953765 -4.5234320314566e-08 -0.09962650829101244 +2.0674 0.7064469370030944 0.7064459164679417 -4.250323017821497e-08 -0.09962662153901913 +2.0675 0.7064471373656216 0.706446116750503 -3.9773090757796786e-08 -0.09962673475275159 +2.0676 0.7064473376967484 0.7064463169430963 -3.7044530610359436e-08 -0.09962684793222017 +2.0677000000000003 0.7064475379964685 0.7064465170457654 -3.431817773903202e-08 -0.09962696107743524 +2.0678 0.7064477382647688 0.7064467170585597 -3.159465945313557e-08 -0.09962707418840708 +2.0679000000000003 0.7064479385016293 0.7064469169815357 -2.8874602217045242e-08 -0.09962718726514602 +2.068 0.7064481387070239 0.7064471168147568 -2.6158631512415362e-08 -0.09962730030766248 +2.0681 0.7064483388809191 0.7064473165582925 -2.344737169137842e-08 -0.09962741331596665 +2.0682000000000005 0.7064485390232746 0.7064475162122197 -2.0741445834297767e-08 -0.09962752629006894 +2.0683000000000002 0.7064487391340442 0.7064477157766217 -1.8041475605568708e-08 -0.0996276392299796 +2.0684 0.7064489392131741 0.706447915251588 -1.5348081110720668e-08 -0.09962775213570893 +2.0685 0.7064491392606049 0.7064481146372154 -1.2661880755687749e-08 -0.09962786500726727 +2.0686 0.7064493392762696 0.706448313933607 -9.98349110065827e-09 -0.09962797784466493 +2.0687 0.7064495392600953 0.7064485131408723 -7.313526725200026e-09 -0.09962809064791217 +2.0688 0.7064497392120022 0.7064487122591279 -4.652600083844549e-09 -0.0996282034170193 +2.0689 0.7064499391319039 0.7064489112884964 -2.001321367309239e-09 -0.09962831615199663 +2.069 0.7064501390197077 0.7064491102291071 6.397016458214999e-10 -0.09962842885285444 +2.0690999999999997 0.7064503388753144 0.7064493090810959 3.2698637165984312e-09 -0.09962854151960306 +2.0692000000000004 0.7064505386986182 0.7064495078446049 5.888562289689536e-09 -0.0996286541522527 +2.0693 0.7064507384895067 0.7064497065197831 8.495197630423168e-09 -0.09962876675081368 +2.0694 0.7064509382478616 0.7064499051067855 1.108917296356593e-08 -0.0996288793152963 +2.0695 0.7064511379735576 0.7064501036057736 1.366989461036583e-08 -0.09962899184571083 +2.0696 0.7064513376664635 0.706450302016915 1.62367721195239e-08 -0.09962910434206754 +2.0697 0.706451537326442 0.706450500340384 1.8789218412043618e-08 -0.0996292168043767 +2.0698000000000003 0.7064517369533485 0.7064506985763608 2.1326649899192085e-08 -0.09962932923264853 +2.0699 0.7064519365470332 0.7064508967250318 2.384848663689043e-08 -0.09962944162689333 +2.07 0.7064521361073399 0.7064510947865899 2.6354152440205558e-08 -0.09962955398712134 +2.0701 0.7064523356341061 0.7064512927612336 2.884307502386274e-08 -0.09962966631334282 +2.0702000000000003 0.7064525351271636 0.7064514906491683 3.131468612714572e-08 -0.09962977860556807 +2.0703 0.7064527345863371 0.7064516884506049 3.376842165614402e-08 -0.0996298908638073 +2.0704000000000002 0.7064529340114465 0.7064518861657603 3.6203721787836374e-08 -0.09963000308807078 +2.0705 0.7064531334023051 0.7064520837948571 3.862003113315471e-08 -0.09963011527836872 +2.0705999999999998 0.7064533327587204 0.7064522813381245 4.101679882718978e-08 -0.09963022743471138 +2.0707000000000004 0.7064535320804941 0.7064524787957971 4.339347868705101e-08 -0.099630339557109 +2.0708 0.706453731367422 0.7064526761681151 4.574952930554155e-08 -0.0996304516455718 +2.0709 0.7064539306192943 0.706452873455325 4.8084414202079206e-08 -0.09963056370011002 +2.071 0.7064541298358955 0.7064530706576787 5.039760192677989e-08 -0.09963067572073392 +2.0711 0.706454329017004 0.7064532677754336 5.268856618362294e-08 -0.0996307877074537 +2.0712 0.7064545281623933 0.706453464808853 5.49567859588207e-08 -0.09963089966027959 +2.0713000000000004 0.7064547272718309 0.7064536617582055 5.720174563184077e-08 -0.0996310115792218 +2.0714 0.7064549263450788 0.7064538586237648 5.9422935091632545e-08 -0.09963112346429051 +2.0715 0.706455125381894 0.7064540554058107 6.161984985979252e-08 -0.09963123531549603 +2.0716 0.7064553243820282 0.7064542521046284 6.379199119811718e-08 -0.09963134713284857 +2.0717000000000003 0.706455523345227 0.7064544487205076 6.59388662265642e-08 -0.09963145891635823 +2.0718 0.7064557222712313 0.7064546452537435 6.805998803600943e-08 -0.0996315706660353 +2.0719000000000003 0.7064559211597772 0.7064548417046368 7.015487578018731e-08 -0.09963168238188996 +2.072 0.7064561200105949 0.7064550380734929 7.222305481446867e-08 -0.09963179406393238 +2.0721 0.7064563188234103 0.7064552343606225 7.42640567930053e-08 -0.09963190571217279 +2.0722000000000005 0.706456517597944 0.7064554305663409 7.627741975720082e-08 -0.09963201732662133 +2.0723000000000003 0.7064567163339119 0.7064556266909687 7.826268825367189e-08 -0.09963212890728827 +2.0724 0.706456915031025 0.7064558227348309 8.021941344180106e-08 -0.09963224045418378 +2.0725 0.7064571136889894 0.7064560186982575 8.214715319782018e-08 -0.099632351967318 +2.0726 0.7064573123075069 0.7064562145815829 8.404547219460767e-08 -0.09963246344670114 +2.0727 0.7064575108862741 0.7064564103851465 8.591394201271085e-08 -0.09963257489234338 +2.0728 0.7064577094249838 0.7064566061092918 8.775214125136821e-08 -0.09963268630425488 +2.0729 0.7064579079233237 0.706456801754367 8.955965559095946e-08 -0.09963279768244583 +2.073 0.7064581063809778 0.7064569973207242 9.133607791964038e-08 -0.09963290902692637 +2.0730999999999997 0.7064583047976252 0.7064571928087204 9.308100839752753e-08 -0.09963302033770667 +2.0732000000000004 0.706458503172941 0.7064573882187164 9.479405455731227e-08 -0.09963313161479688 +2.0733 0.7064587015065965 0.7064575835510771 9.647483141528301e-08 -0.0996332428582072 +2.0734 0.7064588997982587 0.7064577788061718 9.812296150601973e-08 -0.09963335406794778 +2.0735 0.7064590980475906 0.7064579739843733 9.973807501076348e-08 -0.09963346524402875 +2.0736 0.7064592962542511 0.7064581690860585 1.0131980983721367e-07 -0.09963357638646028 +2.0737 0.7064594944178957 0.7064583641116085 1.0286781166810033e-07 -0.09963368749525253 +2.0738000000000003 0.7064596925381765 0.7064585590614068 1.043817340860842e-07 -0.09963379857041563 +2.0739 0.7064598906147408 0.706458753935842 1.058612386153901e-07 -0.09963390961195968 +2.074 0.7064600886472332 0.7064589487353053 1.0730599480160419e-07 -0.09963402061989486 +2.0741 0.7064602866352949 0.7064591434601919 1.087156803157574e-07 -0.09963413159423126 +2.0742000000000003 0.7064604845785638 0.7064593381108996 1.10089980982081e-07 -0.09963424253497905 +2.0743 0.706460682476674 0.7064595326878305 1.1142859088209e-07 -0.09963435344214838 +2.0744000000000002 0.7064608803292569 0.7064597271913888 1.1273121239968598e-07 -0.09963446431574936 +2.0745 0.7064610781359404 0.7064599216219829 1.139975563148321e-07 -0.0996345751557921 +2.0745999999999998 0.7064612758963498 0.7064601159800233 1.1522734183824768e-07 -0.09963468596228675 +2.0747000000000004 0.7064614736101069 0.7064603102659238 1.1642029667732756e-07 -0.09963479673524338 +2.0748 0.7064616712768317 0.7064605044801009 1.1757615712287839e-07 -0.09963490747467213 +2.0749 0.7064618688961403 0.7064606986229738 1.1869466808728246e-07 -0.09963501818058312 +2.075 0.7064620664676466 0.7064608926949643 1.1977558314960057e-07 -0.09963512885298643 +2.0751 0.7064622639909627 0.7064610866964969 1.2081866463536928e-07 -0.09963523949189218 +2.0752 0.7064624614656971 0.7064612806279982 1.2182368364782592e-07 -0.09963535009731044 +2.0753000000000004 0.7064626588914567 0.7064614744898979 1.2279042012688923e-07 -0.0996354606692514 +2.0754 0.7064628562678456 0.7064616682826272 1.237186628977316e-07 -0.09963557120772505 +2.0755 0.7064630535944665 0.7064618620066194 1.246082097297596e-07 -0.09963568171274156 +2.0756 0.7064632508709191 0.7064620556623105 1.2545886734355305e-07 -0.09963579218431098 +2.0757000000000003 0.706463448096802 0.7064622492501378 1.2627045148372318e-07 -0.09963590262244343 +2.0758 0.7064636452717112 0.706462442770541 1.270427869640156e-07 -0.09963601302714897 +2.0759000000000003 0.7064638423952413 0.7064626362239611 1.2777570766731028e-07 -0.09963612339843762 +2.076 0.7064640394669852 0.706462829610841 1.2846905662541874e-07 -0.09963623373631951 +2.0761 0.7064642364865343 0.7064630229316251 1.291226860294925e-07 -0.09963634404080468 +2.0762000000000005 0.7064644334534786 0.7064632161867597 1.297364572577786e-07 -0.09963645431190335 +2.0763000000000003 0.7064646303674063 0.7064634093766915 1.3031024090684462e-07 -0.09963656454962543 +2.0764 0.7064648272279045 0.7064636025018698 1.3084391683321206e-07 -0.09963667475398102 +2.0765 0.7064650240345594 0.7064637955627437 1.3133737416376468e-07 -0.09963678492498025 +2.0766 0.706465220786956 0.7064639885597641 1.3179051131309572e-07 -0.09963689506263308 +2.0767 0.706465417484678 0.7064641814933827 1.3220323604595796e-07 -0.09963700516694965 +2.0768 0.7064656141273084 0.7064643743640524 1.3257546542175258e-07 -0.09963711523793994 +2.0769 0.7064658107144295 0.7064645671722263 1.3290712589514309e-07 -0.09963722527561406 +2.077 0.7064660072456228 0.7064647599183587 1.331981532466664e-07 -0.099637335279982 +2.0770999999999997 0.7064662037204696 0.7064649526029041 1.3344849265906067e-07 -0.09963744525105385 +2.0772000000000004 0.7064664001385503 0.7064651452263178 1.3365809869297918e-07 -0.09963755518883967 +2.0773 0.706466596499445 0.7064653377890551 1.3382693531474588e-07 -0.09963766509334943 +2.0774 0.706466792802734 0.7064655302915718 1.339549759032943e-07 -0.09963777496459329 +2.0775 0.7064669890479962 0.7064657227343238 1.340422032154731e-07 -0.09963788480258114 +2.0776 0.7064671852348117 0.7064659151177669 1.340886094346183e-07 -0.09963799460732307 +2.0777 0.7064673813627601 0.7064661074423569 1.3409419613932827e-07 -0.09963810437882904 +2.0778000000000003 0.7064675774314211 0.70646629970855 1.3405897431734148e-07 -0.09963821411710919 +2.0779 0.706467773440375 0.7064664919168013 1.3398296434125045e-07 -0.09963832382217346 +2.078 0.7064679693892019 0.7064666840675666 1.3386619598584892e-07 -0.0996384334940319 +2.0781 0.7064681652774827 0.7064668761613003 1.337087083934374e-07 -0.09963854313269455 +2.0782000000000003 0.7064683611047984 0.7064670681984566 1.3351055008423152e-07 -0.09963865273817135 +2.0783 0.7064685568707312 0.7064672601794894 1.3327177893207587e-07 -0.09963876231047238 +2.0784000000000002 0.7064687525748636 0.7064674521048511 1.329924621540357e-07 -0.0996388718496076 +2.0785 0.7064689482167792 0.706467643974994 1.3267267628264134e-07 -0.09963898135558702 +2.0786 0.7064691437960624 0.7064678357903689 1.3231250712772424e-07 -0.09963909082842064 +2.0787000000000004 0.7064693393122989 0.7064680275514259 1.3191204980070315e-07 -0.09963920026811846 +2.0788 0.7064695347650749 0.7064682192586138 1.3147140866254237e-07 -0.09963930967469045 +2.0789 0.7064697301539786 0.7064684109123804 1.3099069728211843e-07 -0.09963941904814666 +2.079 0.7064699254785989 0.7064686025131719 1.304700384466284e-07 -0.099639528388497 +2.0791 0.7064701207385263 0.7064687940614333 1.2990956407485377e-07 -0.09963963769575152 +2.0792 0.7064703159333532 0.7064689855576077 1.2930941526573259e-07 -0.09963974696992017 +2.0793000000000004 0.7064705110626728 0.7064691770021372 1.2866974217692895e-07 -0.09963985621101294 +2.0794 0.7064707061260811 0.7064693683954613 1.2799070404218016e-07 -0.09963996541903981 +2.0795 0.7064709011231749 0.7064695597380184 1.2727246911231616e-07 -0.09964007459401072 +2.0796 0.7064710960535536 0.7064697510302447 1.2651521462403448e-07 -0.0996401837359357 +2.0797000000000003 0.7064712909168183 0.7064699422725742 1.2571912671663354e-07 -0.09964029284482462 +2.0798 0.7064714857125722 0.7064701334654393 1.2488440045976823e-07 -0.09964040192068756 +2.0799000000000003 0.706471680440421 0.7064703246092696 1.2401123974242756e-07 -0.09964051096353438 +2.08 0.7064718750999723 0.7064705157044929 1.2309985724517913e-07 -0.09964061997337513 +2.0801 0.7064720696908363 0.7064707067515343 1.2215047439506632e-07 -0.09964072895021969 +2.0802000000000005 0.7064722642126253 0.7064708977508164 1.2116332131356655e-07 -0.09964083789407802 +2.0803000000000003 0.7064724586649549 0.7064710887027594 1.2013863673679404e-07 -0.09964094680496006 +2.0804 0.7064726530474428 0.7064712796077806 1.1907666799468308e-07 -0.09964105568287582 +2.0805 0.7064728473597094 0.7064714704662949 1.1797767091384359e-07 -0.09964116452783517 +2.0806 0.7064730416013787 0.7064716612787139 1.1684190977245823e-07 -0.09964127333984812 +2.0807 0.7064732357720767 0.7064718520454465 1.156696572447713e-07 -0.09964138211892454 +2.0808 0.7064734298714328 0.7064720427668989 1.1446119433169977e-07 -0.09964149086507444 +2.0809 0.7064736238990799 0.7064722334434732 1.1321681029144437e-07 -0.09964159957830766 +2.081 0.7064738178546532 0.7064724240755693 1.1193680255622285e-07 -0.0996417082586342 +2.0810999999999997 0.7064740117377919 0.7064726146635832 1.106214766906366e-07 -0.09964181690606393 +2.0812000000000004 0.7064742055481386 0.706472805207908 1.0927114629799561e-07 -0.09964192552060681 +2.0813 0.7064743992853388 0.7064729957089328 1.0788613295439897e-07 -0.09964203410227274 +2.0814 0.7064745929490424 0.7064731861670432 1.0646676612199868e-07 -0.09964214265107164 +2.0815 0.706474786538902 0.706473376582622 1.0501338308308017e-07 -0.09964225116701346 +2.0816 0.7064749800545744 0.7064735669560471 1.0352632883944834e-07 -0.09964235965010805 +2.0817 0.7064751734957202 0.7064737572876932 1.0200595606732477e-07 -0.09964246810036533 +2.0818000000000003 0.7064753668620039 0.7064739475779312 1.004526250028559e-07 -0.09964257651779526 +2.0819 0.7064755601530937 0.7064741378271278 9.88667033588464e-08 -0.09964268490240766 +2.082 0.7064757533686616 0.7064743280356455 9.724856626577849e-08 -0.09964279325421244 +2.0821 0.7064759465083847 0.7064745182038432 9.559859613303412e-08 -0.09964290157321952 +2.0822000000000003 0.7064761395719437 0.7064747083320753 9.391718260379212e-08 -0.0996430098594388 +2.0823 0.7064763325590232 0.7064748984206919 9.22047224509448e-08 -0.0996431181128802 +2.0824000000000003 0.7064765254693127 0.7064750884700388 9.046161947648401e-08 -0.09964322633355355 +2.0825 0.7064767183025058 0.7064752784804573 8.868828441435661e-08 -0.09964333452146876 +2.0826 0.7064769110583008 0.7064754684522843 8.688513485760607e-08 -0.09964344267663566 +2.0827000000000004 0.7064771037364002 0.7064756583858521 8.505259511612517e-08 -0.09964355079906419 +2.0828 0.7064772963365116 0.7064758482814884 8.319109615767539e-08 -0.09964365888876418 +2.0829 0.7064774888583469 0.706476038139516 8.130107548819099e-08 -0.09964376694574552 +2.083 0.7064776813016234 0.7064762279602532 7.938297704596087e-08 -0.09964387497001809 +2.0831 0.7064778736660622 0.7064764177440133 7.743725111662714e-08 -0.09964398296159176 +2.0832 0.7064780659513905 0.7064766074911049 7.546435421001974e-08 -0.0996440909204764 +2.0833000000000004 0.7064782581573394 0.706476797201831 7.346474895260358e-08 -0.09964419884668185 +2.0834 0.7064784502836459 0.7064769868764901 7.143890398686459e-08 -0.09964430674021796 +2.0835 0.7064786423300512 0.7064771765153754 6.938729386549158e-08 -0.09964441460109456 +2.0836 0.7064788342963024 0.7064773661187753 6.7310398921272e-08 -0.09964452242932154 +2.0837000000000003 0.7064790261821517 0.7064775556869725 6.520870517862098e-08 -0.09964463022490876 +2.0838 0.7064792179873562 0.7064777452202444 6.308270422000772e-08 -0.099644737987866 +2.0839000000000003 0.7064794097116791 0.7064779347188634 6.093289309054561e-08 -0.09964484571820317 +2.084 0.7064796013548881 0.7064781241830964 5.8759774154010236e-08 -0.0996449534159301 +2.0841 0.7064797929167568 0.7064783136132045 5.6563855013042064e-08 -0.0996450610810566 +2.0842 0.7064799843970642 0.7064785030094438 5.434564835475608e-08 -0.09964516871359254 +2.0843000000000003 0.706480175795595 0.7064786923720644 5.210567185359727e-08 -0.09964527631354768 +2.0844 0.7064803671121394 0.7064788817013108 4.984444803950161e-08 -0.09964538388093187 +2.0845 0.7064805583464933 0.706479070997422 4.756250418166963e-08 -0.09964549141575499 +2.0846 0.7064807494984584 0.7064792602606316 4.526037216193157e-08 -0.09964559891802682 +2.0847 0.7064809405678419 0.7064794494911668 4.293858835505149e-08 -0.0996457063877572 +2.0848 0.7064811315544572 0.7064796386892493 4.059769350556186e-08 -0.09964581382495591 +2.0849 0.7064813224581231 0.7064798278550948 3.823823258204684e-08 -0.09964592122963278 +2.085 0.7064815132786646 0.7064800169889136 3.586075469387551e-08 -0.09964602860179765 +2.0850999999999997 0.7064817040159121 0.7064802060909091 3.34658129073212e-08 -0.09964613594146024 +2.0852000000000004 0.7064818946697031 0.7064803951612796 3.1053964160560055e-08 -0.09964624324863043 +2.0853 0.7064820852398801 0.706480584200217 2.862576912489312e-08 -0.099646350523318 +2.0854 0.7064822757262922 0.7064807732079071 2.6181792053825426e-08 -0.09964645776553277 +2.0855 0.7064824661287941 0.7064809621845297 2.3722600673778405e-08 -0.0996465649752845 +2.0856 0.7064826564472474 0.7064811511302583 2.124876604704673e-08 -0.09964667215258301 +2.0857 0.706482846681519 0.7064813400452608 1.876086243648989e-08 -0.09964677929743809 +2.0858000000000003 0.7064830368314825 0.7064815289296976 1.625946717022375e-08 -0.09964688640985953 +2.0859 0.7064832268970176 0.7064817177837244 1.3745160514118393e-08 -0.09964699348985706 +2.086 0.7064834168780101 0.7064819066074896 1.1218525534754942e-08 -0.09964710053744048 +2.0861 0.7064836067743526 0.7064820954011357 8.680147964117146e-09 -0.09964720755261962 +2.0862000000000003 0.7064837965859434 0.7064822841647986 6.1306160608134985e-09 -0.09964731453540415 +2.0863 0.7064839863126876 0.7064824728986087 3.570520475636163e-09 -0.09964742148580397 +2.0864000000000003 0.7064841759544966 0.7064826616026887 1.000454116252547e-09 -0.09964752840382879 +2.0865 0.7064843655112876 0.7064828502771561 -1.5789879863684075e-09 -0.09964763528948838 +2.0866 0.706484554982985 0.706483038922121 -4.1672088271424435e-09 -0.09964774214279246 +2.0867000000000004 0.7064847443695192 0.7064832275376877 -6.763609551770078e-09 -0.09964784896375083 +2.0868 0.7064849336708272 0.7064834161239539 -9.367589609392268e-09 -0.0996479557523732 +2.0869 0.7064851228868525 0.706483604681011 -1.1978546874021057e-08 -0.09964806250866945 +2.087 0.7064853120175446 0.7064837932089436 -1.4595877800231e-08 -0.0996481692326492 +2.0871 0.7064855010628603 0.7064839817078299 -1.7218977550661346e-08 -0.0996482759243223 +2.0872 0.7064856900227623 0.7064841701777417 -1.9847240145202255e-08 -0.0996483825836984 +2.0873000000000004 0.7064858788972197 0.7064843586187438 -2.2480058591966418e-08 -0.09964848921078726 +2.0874 0.7064860676862086 0.7064845470308954 -2.5116825035607915e-08 -0.09964859580559865 +2.0875 0.7064862563897114 0.706484735414248 -2.7756930892196968e-08 -0.09964870236814227 +2.0876 0.7064864450077174 0.706484923768848 -3.039976698994938e-08 -0.0996488088984279 +2.0877000000000003 0.7064866335402216 0.7064851120947337 -3.304472371407595e-08 -0.09964891539646525 +2.0878 0.7064868219872262 0.7064853003919382 -3.569119114165721e-08 -0.09964902186226408 +2.0879000000000003 0.7064870103487397 0.706485488660487 -3.83385591877939e-08 -0.09964912829583406 +2.088 0.7064871986247774 0.7064856769003995 -4.0986217739614333e-08 -0.09964923469718492 +2.0881 0.7064873868153612 0.7064858651116886 -4.363355680169303e-08 -0.09964934106632643 +2.0882 0.7064875749205186 0.7064860532943603 -4.6279966637295146e-08 -0.09964944740326818 +2.0883000000000003 0.7064877629402848 0.7064862414484147 -4.892483790438964e-08 -0.09964955370802003 +2.0884 0.7064879508747011 0.7064864295738448 -5.1567561800227625e-08 -0.0996496599805916 +2.0885 0.7064881387238153 0.7064866176706375 -5.4207530198304224e-08 -0.0996497662209927 +2.0886 0.7064883264876816 0.7064868057387726 -5.684413579057877e-08 -0.09964987242923291 +2.0887000000000002 0.7064885141663608 0.706486993778224 -5.9476772224517985e-08 -0.09964997860532204 +2.0888 0.7064887017599202 0.7064871817889584 -6.210483424490959e-08 -0.09965008474926967 +2.0889 0.7064888892684336 0.7064873697709368 -6.472771783101391e-08 -0.09965019086108559 +2.089 0.7064890766919811 0.7064875577241132 -6.734482033837752e-08 -0.09965029694077944 +2.0890999999999997 0.7064892640306495 0.7064877456484353 -6.995554063327428e-08 -0.09965040298836092 +2.0892000000000004 0.7064894512845321 0.7064879335438445 -7.25592792334348e-08 -0.09965050900383977 +2.0893 0.706489638453728 0.7064881214102756 -7.515543844422226e-08 -0.0996506149872256 +2.0894 0.7064898255383436 0.706488309247657 -7.774342250087968e-08 -0.09965072093852818 +2.0895 0.7064900125384908 0.7064884970559107 -8.032263769299636e-08 -0.09965082685775711 +2.0896 0.7064901994542881 0.7064886848349526 -8.28924925158625e-08 -0.0996509327449221 +2.0897 0.7064903862858609 0.706488872584692 -8.545239779233355e-08 -0.09965103860003278 +2.0898000000000003 0.7064905730333398 0.7064890603050319 -8.800176681724586e-08 -0.09965114442309886 +2.0899 0.7064907596968628 0.7064892479958693 -9.054001548925578e-08 -0.09965125021413002 +2.09 0.7064909462765734 0.7064894356570945 -9.306656244181116e-08 -0.09965135597313589 +2.0901 0.7064911327726213 0.7064896232885925 -9.55808291827967e-08 -0.09965146170012615 +2.0902000000000003 0.706491319185163 0.7064898108902409 -9.808224021769923e-08 -0.09965156739511041 +2.0903 0.7064915055143599 0.7064899984619117 -1.0057022319012038e-07 -0.09965167305809836 +2.0904000000000003 0.7064916917603812 0.7064901860034714 -1.0304420900841132e-07 -0.09965177868909966 +2.0905 0.7064918779234008 0.7064903735147794 -1.0550363197490975e-07 -0.09965188428812397 +2.0906 0.7064920640035991 0.7064905609956896 -1.0794792991517671e-07 -0.09965198985518087 +2.0907000000000004 0.7064922500011626 0.7064907484460502 -1.1037654430896826e-07 -0.09965209539028011 +2.0908 0.7064924359162834 0.7064909358657028 -1.1278892041513555e-07 -0.09965220089343124 +2.0909 0.70649262174916 0.7064911232544835 -1.1518450740780062e-07 -0.09965230636464395 +2.091 0.7064928074999963 0.706491310612222 -1.1756275848651132e-07 -0.09965241180392784 +2.0911 0.7064929931690025 0.7064914979387433 -1.1992313100374352e-07 -0.09965251721129259 +2.0912 0.7064931787563937 0.7064916852338654 -1.2226508660541369e-07 -0.09965262258674779 +2.0913000000000004 0.7064933642623916 0.7064918724974014 -1.2458809133843174e-07 -0.0996527279303031 +2.0914 0.7064935496872231 0.7064920597291582 -1.2689161576692753e-07 -0.09965283324196811 +2.0915 0.7064937350311209 0.7064922469289374 -1.2917513511102874e-07 -0.0996529385217524 +2.0916 0.706493920294323 0.7064924340965348 -1.3143812935441368e-07 -0.09965304376966566 +2.0917000000000003 0.7064941054770736 0.7064926212317404 -1.336800833588031e-07 -0.09965314898571742 +2.0918 0.7064942905796217 0.7064928083343399 -1.3590048700100332e-07 -0.09965325416991742 +2.0919 0.7064944756022217 0.7064929954041125 -1.3809883526311184e-07 -0.0996533593222752 +2.092 0.7064946605451339 0.706493182440832 -1.402746283608869e-07 -0.09965346444280036 +2.0921 0.7064948454086233 0.7064933694442674 -1.424273718669128e-07 -0.0996535695315025 +2.0922 0.7064950301929603 0.7064935564141823 -1.4455657680427503e-07 -0.0996536745883912 +2.0923000000000003 0.7064952148984209 0.7064937433503351 -1.4666175975931728e-07 -0.09965377961347609 +2.0924 0.7064953995252858 0.7064939302524789 -1.4874244301001094e-07 -0.09965388460676675 +2.0925 0.7064955840738408 0.706494117120362 -1.507981546057524e-07 -0.09965398956827283 +2.0926 0.7064957685443768 0.7064943039537277 -1.5282842850440626e-07 -0.09965409449800389 +2.0927000000000002 0.7064959529371895 0.7064944907523143 -1.548328046607761e-07 -0.09965419939596945 +2.0928 0.7064961372525791 0.706494677515855 -1.5681082913415745e-07 -0.09965430426217917 +2.0929 0.7064963214908515 0.7064948642440785 -1.5876205418374756e-07 -0.09965440909664258 +2.093 0.7064965056523165 0.7064950509367085 -1.6068603838140239e-07 -0.09965451389936925 +2.0930999999999997 0.7064966897372892 0.7064952375934646 -1.6258234670878113e-07 -0.09965461867036884 +2.0932000000000004 0.7064968737460885 0.7064954242140609 -1.6445055064581715e-07 -0.09965472340965081 +2.0933 0.7064970576790388 0.7064956107982079 -1.6629022829214857e-07 -0.09965482811722483 +2.0934 0.706497241536468 0.7064957973456112 -1.681009644260989e-07 -0.0996549327931004 +2.0935 0.7064974253187087 0.7064959838559717 -1.698823506347813e-07 -0.0996550374372871 +2.0936 0.7064976090260983 0.7064961703289867 -1.7163398537307917e-07 -0.09965514204979449 +2.0937 0.7064977926589775 0.7064963567643487 -1.7335547408334206e-07 -0.09965524663063208 +2.0938000000000003 0.7064979762176922 0.7064965431617465 -1.7504642925783576e-07 -0.09965535117980955 +2.0939 0.7064981597025912 0.7064967295208645 -1.7670647054976452e-07 -0.09965545569733636 +2.094 0.7064983431140284 0.7064969158413832 -1.7833522485480313e-07 -0.09965556018322207 +2.0941 0.7064985264523607 0.7064971021229789 -1.7993232637181222e-07 -0.09965566463747622 +2.0942000000000003 0.7064987097179491 0.7064972883653247 -1.8149741671386055e-07 -0.09965576906010834 +2.0943 0.7064988929111591 0.7064974745680894 -1.8303014497067505e-07 -0.099655873451128 +2.0944000000000003 0.7064990760323586 0.7064976607309383 -1.8453016777802977e-07 -0.09965597781054474 +2.0945 0.7064992590819199 0.706497846853533 -1.8599714943223766e-07 -0.09965608213836802 +2.0946 0.7064994420602191 0.7064980329355321 -1.8743076192831443e-07 -0.0996561864346075 +2.0947000000000005 0.7064996249676345 0.70649821897659 -1.8883068505712308e-07 -0.09965629069927262 +2.0948 0.706499807804549 0.7064984049763583 -1.9019660647129344e-07 -0.09965639493237294 +2.0949 0.706499990571348 0.706498590934485 -1.9152822171644712e-07 -0.09965649913391797 +2.095 0.7065001732684205 0.706498776850615 -1.928252343734449e-07 -0.09965660330391721 +2.0951 0.7065003558961582 0.7064989627243904 -1.9408735606532557e-07 -0.0996567074423802 +2.0952 0.7065005384549561 0.7064991485554499 -1.9531430653016435e-07 -0.09965681154931648 +2.0953000000000004 0.7065007209452117 0.7064993343434297 -1.965058137112785e-07 -0.0996569156247355 +2.0954 0.7065009033673257 0.7064995200879629 -1.9766161378498293e-07 -0.09965701966864682 +2.0955 0.7065010857217018 0.7064997057886797 -1.9878145123344848e-07 -0.09965712368105994 +2.0956 0.7065012680087452 0.706499891445208 -1.9986507891756045e-07 -0.0996572276619843 +2.0957000000000003 0.706501450228865 0.7065000770571731 -2.0091225809426572e-07 -0.09965733161142948 +2.0958 0.706501632382472 0.7065002626241977 -2.0192275849290064e-07 -0.09965743552940497 +2.0959 0.7065018144699791 0.7065004481459023 -2.0289635836723274e-07 -0.0996575394159202 +2.096 0.7065019964918025 0.7065006336219048 -2.0383284453015516e-07 -0.09965764327098475 +2.0961 0.7065021784483594 0.7065008190518214 -2.0473201241266725e-07 -0.09965774709460803 +2.0962 0.70650236034007 0.7065010044352656 -2.055936661124469e-07 -0.09965785088679957 +2.0963000000000003 0.7065025421673559 0.7065011897718495 -2.06417618421606e-07 -0.09965795464756887 +2.0964 0.7065027239306408 0.7065013750611829 -2.072036908683239e-07 -0.09965805837692537 +2.0965 0.7065029056303505 0.706501560302874 -2.0795171375501131e-07 -0.09965816207487856 +2.0966 0.7065030872669118 0.706501745496529 -2.0866152622422973e-07 -0.09965826574143791 +2.0967000000000002 0.7065032688407535 0.7065019306417526 -2.0933297625522207e-07 -0.09965836937661283 +2.0968 0.7065034503523064 0.7065021157381481 -2.0996592070554598e-07 -0.09965847298041289 +2.0969 0.706503631802002 0.7065023007853177 -2.1056022535964614e-07 -0.09965857655284752 +2.097 0.7065038131902734 0.7065024857828616 -2.111157649357931e-07 -0.09965868009392616 +2.0970999999999997 0.7065039945175552 0.706502670730379 -2.116324231069e-07 -0.09965878360365835 +2.0972000000000004 0.7065041757842825 0.7065028556274682 -2.121100925525643e-07 -0.09965888708205349 +2.0973 0.706504356990892 0.7065030404737259 -2.1254867497641494e-07 -0.09965899052912101 +2.0974 0.706504538137821 0.7065032252687484 -2.129480811061124e-07 -0.09965909394487038 +2.0975 0.7065047192255078 0.7065034100121308 -2.133082307072265e-07 -0.09965919732931106 +2.0976 0.7065049002543915 0.7065035947034679 -2.1362905263180854e-07 -0.09965930068245249 +2.0977 0.7065050812249117 0.7065037793423532 -2.1391048480798314e-07 -0.09965940400430412 +2.0978000000000003 0.7065052621375086 0.7065039639283803 -2.14152474246887e-07 -0.09965950729487538 +2.0979 0.706505442992623 0.7065041484611416 -2.1435497708083284e-07 -0.0996596105541757 +2.098 0.7065056237906957 0.7065043329402299 -2.1451795854596223e-07 -0.09965971378221453 +2.0981 0.7065058045321679 0.7065045173652371 -2.146413929822455e-07 -0.09965981697900128 +2.0982000000000003 0.7065059852174815 0.7065047017357556 -2.1472526385429846e-07 -0.09965992014454543 +2.0983 0.7065061658470777 0.706504886051377 -2.1476956374444356e-07 -0.09966002327885637 +2.0984000000000003 0.7065063464213981 0.7065050703116936 -2.1477429435617923e-07 -0.09966012638194355 +2.0985 0.7065065269408838 0.7065052545162973 -2.1473946651071052e-07 -0.09966022945381636 +2.0986 0.706506707405976 0.7065054386647804 -2.146651001504185e-07 -0.09966033249448425 +2.0987000000000005 0.7065068878171153 0.7065056227567356 -2.1455122428334916e-07 -0.09966043550395656 +2.0988 0.7065070681747423 0.7065058067917558 -2.1439787703525504e-07 -0.09966053848224277 +2.0989 0.7065072484792965 0.706505990769435 -2.142051056287786e-07 -0.09966064142935227 +2.099 0.7065074287312172 0.706506174689367 -2.1397296631059382e-07 -0.0996607443452945 +2.0991 0.706507608930943 0.7065063585511471 -2.137015244242646e-07 -0.09966084723007884 +2.0992 0.7065077890789112 0.7065065423543707 -2.133908543408558e-07 -0.09966095008371467 +2.0993000000000004 0.7065079691755587 0.7065067260986344 -2.1304103942076935e-07 -0.09966105290621136 +2.0994 0.7065081492213212 0.7065069097835359 -2.1265217203109144e-07 -0.09966115569757839 +2.0995 0.7065083292166335 0.7065070934086741 -2.1222435350048974e-07 -0.09966125845782511 +2.0995999999999997 0.7065085091619288 0.7065072769736489 -2.1175769412268286e-07 -0.09966136118696091 +2.0997000000000003 0.7065086890576389 0.706507460478061 -2.112523130870514e-07 -0.09966146388499514 +2.0998 0.7065088689041952 0.7065076439215134 -2.1070833847516846e-07 -0.09966156655193727 +2.0999 0.7065090487020265 0.7065078273036103 -2.1012590721916635e-07 -0.09966166918779665 +2.1 0.7065092284515603 0.706508010623957 -2.0950516507398098e-07 -0.09966177179258258 +2.1001 0.7065094081532227 0.7065081938821611 -2.088462665479629e-07 -0.09966187436630455 +2.1002 0.706509587807438 0.7065083770778314 -2.081493749375718e-07 -0.09966197690897184 +2.1003000000000003 0.7065097674146283 0.706508560210579 -2.0741466222329308e-07 -0.09966207942059387 +2.1004 0.7065099469752143 0.7065087432800166 -2.0664230903147396e-07 -0.09966218190118002 +2.1005 0.7065101264896139 0.7065089262857593 -2.05832504630854e-07 -0.0996622843507396 +2.1006 0.7065103059582434 0.706509109227424 -2.0498544684929842e-07 -0.099662386769282 +2.1007000000000002 0.706510485381517 0.7065092921046301 -2.0410134202522578e-07 -0.0996624891568166 +2.1008 0.7065106647598458 0.7065094749169991 -2.031804049971997e-07 -0.09966259151335272 +2.1009 0.7065108440936395 0.7065096576641549 -2.0222285900678427e-07 -0.09966269383889971 +2.101 0.7065110233833043 0.7065098403457243 -2.0122893566731914e-07 -0.09966279613346697 +2.1010999999999997 0.7065112026292447 0.7065100229613361 -2.0019887490146937e-07 -0.09966289839706383 +2.1012000000000004 0.7065113818318619 0.7065102055106223 -1.9913292487183654e-07 -0.0996630006296996 +2.1013 0.7065115609915547 0.7065103879932171 -1.9803134195320315e-07 -0.09966310283138367 +2.1014 0.7065117401087189 0.706510570408758 -1.9689439065620484e-07 -0.09966320500212537 +2.1015 0.7065119191837469 0.706510752756885 -1.957223435371247e-07 -0.09966330714193396 +2.1016 0.706512098217029 0.7065109350372418 -1.945154811909544e-07 -0.09966340925081887 +2.1017 0.7065122772089517 0.7065111172494748 -1.932740920917997e-07 -0.09966351132878941 +2.1018000000000003 0.7065124561598985 0.7065112993932332 -1.9199847263451364e-07 -0.09966361337585486 +2.1019 0.7065126350702496 0.7065114814681703 -1.9068892699244944e-07 -0.09966371539202461 +2.102 0.7065128139403818 0.7065116634739421 -1.893457670654186e-07 -0.0996638173773079 +2.1021 0.7065129927706688 0.7065118454102084 -1.8796931239989378e-07 -0.09966391933171415 +2.1022000000000003 0.7065131715614801 0.7065120272766321 -1.865598901196197e-07 -0.09966402125525259 +2.1023 0.7065133503131822 0.7065122090728803 -1.8511783483540767e-07 -0.09966412314793263 +2.1024000000000003 0.7065135290261377 0.706512390798623 -1.8364348858615487e-07 -0.09966422500976348 +2.1025 0.7065137077007051 0.7065125724535352 -1.8213720074516937e-07 -0.09966432684075449 +2.1026 0.7065138863372395 0.7065127540372941 -1.8059932794384226e-07 -0.09966442864091496 +2.1027000000000005 0.7065140649360921 0.7065129355495822 -1.7903023397450313e-07 -0.09966453041025422 +2.1028000000000002 0.7065142434976098 0.7065131169900852 -1.7743028971409225e-07 -0.09966463214878155 +2.1029 0.7065144220221358 0.7065132983584932 -1.7579987303395495e-07 -0.09966473385650625 +2.103 0.7065146005100085 0.7065134796545005 -1.7413936872004432e-07 -0.09966483553343759 +2.1031 0.7065147789615628 0.7065136608778051 -1.724491683653684e-07 -0.0996649371795849 +2.1032 0.706514957377129 0.7065138420281099 -1.7072967029366226e-07 -0.09966503879495743 +2.1033000000000004 0.7065151357570328 0.7065140231051218 -1.6898127945703945e-07 -0.09966514037956448 +2.1034 0.7065153141015961 0.7065142041085521 -1.6720440733884734e-07 -0.09966524193341533 +2.1035 0.7065154924111355 0.7065143850381173 -1.653994718634616e-07 -0.09966534345651931 +2.1035999999999997 0.7065156706859639 0.706514565893537 -1.6356689729393747e-07 -0.09966544494888564 +2.1037000000000003 0.7065158489263887 0.706514746674537 -1.6170711412619165e-07 -0.09966554641052364 +2.1038 0.7065160271327133 0.7065149273808468 -1.5982055899879666e-07 -0.09966564784144255 +2.1039 0.7065162053052358 0.7065151080122007 -1.579076746010405e-07 -0.09966574924165159 +2.104 0.70651638344425 0.7065152885683386 -1.5596890954108766e-07 -0.09966585061116015 +2.1041 0.7065165615500446 0.7065154690490042 -1.5400471825403883e-07 -0.09966595194997743 +2.1042 0.7065167396229026 0.7065156494539471 -1.520155609047863e-07 -0.09966605325811266 +2.1043000000000003 0.7065169176631032 0.7065158297829213 -1.5000190325790974e-07 -0.09966615453557513 +2.1044 0.7065170956709197 0.706516010035686 -1.4796421659614423e-07 -0.09966625578237405 +2.1045 0.7065172736466209 0.7065161902120056 -1.4590297759027593e-07 -0.09966635699851875 +2.1046 0.7065174515904695 0.7065163703116498 -1.43818668193324e-07 -0.09966645818401841 +2.1047000000000002 0.7065176295027242 0.7065165503343934 -1.4171177553125303e-07 -0.09966655933888235 +2.1048 0.7065178073836373 0.7065167302800164 -1.3958279178327704e-07 -0.09966666046311978 +2.1049 0.7065179852334564 0.7065169101483042 -1.3743221406736783e-07 -0.09966676155673997 +2.105 0.7065181630524231 0.7065170899390474 -1.3526054433617152e-07 -0.09966686261975204 +2.1050999999999997 0.7065183408407743 0.7065172696520424 -1.3306828924343483e-07 -0.09966696365216536 +2.1052000000000004 0.706518518598741 0.706517449287091 -1.3085596004165645e-07 -0.09966706465398911 +2.1053 0.7065186963265486 0.7065176288440005 -1.2862407243983964e-07 -0.09966716562523256 +2.1054 0.7065188740244168 0.7065178083225836 -1.2637314651328668e-07 -0.09966726656590487 +2.1055 0.7065190516925599 0.7065179877226588 -1.2410370655267788e-07 -0.09966736747601529 +2.1056 0.7065192293311866 0.7065181670440506 -1.2181628096866182e-07 -0.09966746835557307 +2.1057 0.7065194069404996 0.7065183462865884 -1.1951140214613853e-07 -0.0996675692045874 +2.1058000000000003 0.706519584520696 0.7065185254501081 -1.1718960634017617e-07 -0.0996676700230675 +2.1059 0.7065197620719671 0.706518704534451 -1.1485143354070249e-07 -0.0996677708110226 +2.106 0.7065199395944983 0.7065188835394645 -1.1249742734240065e-07 -0.09966787156846191 +2.1061 0.7065201170884692 0.7065190624650015 -1.1012813483368689e-07 -0.09966797229539462 +2.1062000000000003 0.706520294554053 0.7065192413109211 -1.0774410644925903e-07 -0.09966807299182989 +2.1063 0.706520471991418 0.7065194200770889 -1.0534589585907417e-07 -0.09966817365777708 +2.1064000000000003 0.7065206494007255 0.7065195987633751 -1.02934059834775e-07 -0.09966827429324523 +2.1065 0.706520826782131 0.706519777369657 -1.0050915811524869e-07 -0.09966837489824364 +2.1066 0.7065210041357843 0.7065199558958175 -9.807175328779838e-08 -0.0996684754727814 +2.1067000000000005 0.7065211814618291 0.7065201343417458 -9.562241064763055e-08 -0.09966857601686785 +2.1068000000000002 0.7065213587604025 0.7065203127073372 -9.316169806861813e-08 -0.09966867653051203 +2.1069 0.7065215360316359 0.7065204909924929 -9.069018588100247e-08 -0.09966877701372323 +2.107 0.7065217132756545 0.7065206691971202 -8.82084467239419e-08 -0.0996688774665106 +2.1071 0.7065218904925771 0.7065208473211327 -8.571705542668312e-08 -0.09966897788888328 +2.1072 0.7065220676825164 0.7065210253644504 -8.321658885764027e-08 -0.09966907828085048 +2.1073000000000004 0.7065222448455791 0.7065212033269992 -8.070762581770946e-08 -0.09966917864242138 +2.1074 0.7065224219818657 0.7065213812087117 -7.819074688067418e-08 -0.09966927897360518 +2.1075 0.7065225990914699 0.7065215590095257 -7.566653427437675e-08 -0.09966937927441101 +2.1075999999999997 0.7065227761744793 0.7065217367293866 -7.31355717389047e-08 -0.09966947954484805 +2.1077000000000004 0.7065229532309758 0.7065219143682449 -7.059844439648646e-08 -0.09966957978492544 +2.1078 0.7065231302610344 0.7065220919260582 -6.80557386140146e-08 -0.09966967999465237 +2.1079 0.706523307264724 0.7065222694027905 -6.550804186470152e-08 -0.09966978017403805 +2.108 0.7065234842421071 0.7065224467984113 -6.295594259667428e-08 -0.09966988032309154 +2.1081 0.7065236611932397 0.7065226241128967 -6.040003009506398e-08 -0.09966998044182201 +2.1082 0.706523838118172 0.7065228013462297 -5.784089434864893e-08 -0.09967008053023864 +2.1083000000000003 0.7065240150169472 0.7065229784983988 -5.5279125906523147e-08 -0.09967018058835057 +2.1084 0.7065241918896028 0.7065231555694 -5.271531575102781e-08 -0.09967028061616699 +2.1085 0.7065243687361694 0.7065233325592344 -5.015005515680501e-08 -0.09967038061369697 +2.1086 0.7065245455566715 0.7065235094679099 -4.758393555527249e-08 -0.09967048058094968 +2.1087000000000002 0.7065247223511273 0.7065236862954407 -4.501754839497836e-08 -0.09967058051793422 +2.1088 0.7065248991195483 0.7065238630418478 -4.245148501179504e-08 -0.09967068042465976 +2.1089 0.70652507586194 0.706524039707158 -3.9886336487485055e-08 -0.09967078030113545 +2.109 0.7065252525783017 0.7065242162914049 -3.7322693518106013e-08 -0.09967088014737042 +2.1090999999999998 0.7065254292686259 0.7065243927946279 -3.476114627078749e-08 -0.09967097996337378 +2.1092000000000004 0.706525605932899 0.7065245692168731 -3.220228425625596e-08 -0.09967107974915464 +2.1093 0.7065257825711013 0.7065247455581924 -2.9646696188484825e-08 -0.09967117950472212 +2.1094 0.7065259591832062 0.7065249218186449 -2.7094969850226247e-08 -0.09967127923008536 +2.1095 0.7065261357691813 0.7065250979982952 -2.4547691957702705e-08 -0.09967137892525346 +2.1096 0.7065263123289879 0.7065252740972146 -2.2005448025840674e-08 -0.09967147859023552 +2.1097 0.7065264888625807 0.7065254501154803 -1.9468822235781114e-08 -0.09967157822504068 +2.1098000000000003 0.7065266653699085 0.706525626053176 -1.693839729371635e-08 -0.09967167782967802 +2.1099 0.7065268418509139 0.7065258019103919 -1.4414754306857347e-08 -0.09967177740415667 +2.11 0.7065270183055326 0.706525977687224 -1.1898472646824226e-08 -0.09967187694848575 +2.1101 0.7065271947336945 0.7065261533837746 -9.390129811302078e-09 -0.0996719764626743 +2.1102000000000003 0.7065273711353239 0.7065263290001518 -6.890301295671419e-09 -0.09967207594673146 +2.1103 0.7065275475103381 0.7065265045364704 -4.399560461602892e-09 -0.09967217540066625 +2.1104000000000003 0.7065277238586487 0.7065266799928516 -1.918478404784596e-09 -0.09967227482448786 +2.1105 0.7065279001801612 0.706526855369422 5.523761725800824e-10 -0.09967237421820536 +2.1106 0.7065280764747749 0.706527030666314 3.012437102718757e-09 -0.09967247358182778 +2.1107000000000005 0.7065282527423827 0.706527205883667 5.461140865047065e-09 -0.0996725729153642 +2.1108000000000002 0.7065284289828724 0.706527381021626 7.897926737956973e-09 -0.09967267221882377 +2.1109 0.706528605196125 0.7065275560803417 1.0322236898563375e-08 -0.09967277149221551 +2.111 0.7065287813820158 0.7065277310599712 1.2733516577961845e-08 -0.09967287073554855 +2.1111 0.7065289575404141 0.7065279059606773 1.5131214171383578e-08 -0.09967296994883192 +2.1112 0.7065291336711836 0.7065280807826285 1.7514781368299648e-08 -0.09967306913207467 +2.1113000000000004 0.7065293097741819 0.7065282555259993 1.988367328252527e-08 -0.09967316828528588 +2.1114 0.7065294858492608 0.70652843019097 2.2237348562374748e-08 -0.09967326740847464 +2.1115 0.7065296618962663 0.7065286047777269 2.4575269538112954e-08 -0.09967336650165 +2.1115999999999997 0.7065298379150389 0.7065287792864615 2.689690231996722e-08 -0.09967346556482097 +2.1117000000000004 0.7065300139054131 0.7065289537173713 2.920171694210938e-08 -0.09967356459799667 +2.1118 0.706530189867218 0.7065291280706596 3.1489187465871815e-08 -0.09967366360118611 +2.1119 0.7065303658002773 0.7065293023465347 3.375879209857602e-08 -0.09967376257439838 +2.112 0.7065305417044083 0.7065294765452114 3.6010013332310464e-08 -0.09967386151764251 +2.1121 0.7065307175794238 0.7065296506669089 3.824233804974875e-08 -0.09967396043092752 +2.1122 0.7065308934251306 0.7065298247118525 4.045525763343716e-08 -0.09967405931426249 +2.1123000000000003 0.70653106924133 0.7065299986802731 4.264826810283784e-08 -0.0996741581676564 +2.1124 0.7065312450278183 0.7065301725724062 4.482087019239134e-08 -0.09967425699111836 +2.1125 0.7065314207843865 0.7065303463884935 4.6972569512845896e-08 -0.09967435578465741 +2.1126 0.7065315965108199 0.7065305201287808 4.910287662932e-08 -0.0996744545482825 +2.1127000000000002 0.7065317722068987 0.7065306937935203 5.1211307177528864e-08 -0.0996745532820027 +2.1128 0.7065319478723986 0.7065308673829684 5.3297381990419224e-08 -0.09967465198582703 +2.1129000000000002 0.7065321235070896 0.7065310408973873 5.536062718317081e-08 -0.09967475065976454 +2.113 0.7065322991107367 0.7065312143370437 5.7400574281565864e-08 -0.09967484930382424 +2.1130999999999998 0.7065324746831003 0.706531387702209 5.9416760317398953e-08 -0.09967494791801511 +2.1132000000000004 0.7065326502239354 0.7065315609931604 6.140872792909091e-08 -0.09967504650234615 +2.1133 0.7065328257329926 0.7065317342101793 6.337602548658894e-08 -0.09967514505682644 +2.1134 0.7065330012100176 0.7065319073535521 6.531820716422498e-08 -0.09967524358146496 +2.1135 0.7065331766547513 0.70653208042357 6.723483306908529e-08 -0.09967534207627074 +2.1136 0.7065333520669298 0.7065322534205282 6.91254693173382e-08 -0.09967544054125275 +2.1137 0.7065335274462848 0.706532426344727 7.098968815219542e-08 -0.09967553897641997 +2.1138000000000003 0.7065337027925436 0.7065325991964715 7.282706802891337e-08 -0.09967563738178144 +2.1139 0.7065338781054289 0.706532771976071 7.463719371193778e-08 -0.09967573575734619 +2.114 0.7065340533846591 0.7065329446838386 7.641965636337456e-08 -0.09967583410312317 +2.1141 0.7065342286299481 0.7065331173200924 7.817405365574681e-08 -0.09967593241912134 +2.1142000000000003 0.7065344038410055 0.7065332898851544 7.989998983964908e-08 -0.09967603070534971 +2.1143 0.7065345790175369 0.7065334623793508 8.15970758391571e-08 -0.09967612896181723 +2.1144000000000003 0.7065347541592444 0.7065336348030121 8.326492934897234e-08 -0.09967622718853296 +2.1145 0.7065349292658248 0.7065338071564728 8.490317490207622e-08 -0.09967632538550583 +2.1146 0.7065351043369721 0.7065339794400709 8.651144398422184e-08 -0.09967642355274486 +2.1147000000000005 0.7065352793723758 0.706534151654149 8.808937508250625e-08 -0.09967652169025899 +2.1148000000000002 0.7065354543717215 0.7065343237990525 8.963661378771914e-08 -0.09967661979805714 +2.1149 0.7065356293346917 0.7065344958751315 9.115281287414012e-08 -0.09967671787614837 +2.115 0.706535804260965 0.7065346678827392 9.263763234637623e-08 -0.09967681592454164 +2.1151 0.7065359791502158 0.7065348398222324 9.40907395746704e-08 -0.09967691394324585 +2.1152 0.706536154002116 0.7065350116939715 9.551180932612646e-08 -0.09967701193227 +2.1153000000000004 0.7065363288163335 0.70653518349832 9.690052384103698e-08 -0.09967710989162301 +2.1154 0.7065365035925331 0.7065353552356453 9.825657289880274e-08 -0.0996772078213139 +2.1155 0.7065366783303764 0.7065355269063175 9.957965392548562e-08 -0.09967730572135161 +2.1155999999999997 0.7065368530295212 0.7065356985107101 1.0086947199380858e-07 -0.09967740359174505 +2.1157000000000004 0.7065370276896232 0.7065358700491995 1.0212573996540297e-07 -0.09967750143250319 +2.1158 0.7065372023103346 0.7065360415221651 1.0334817850815581e-07 -0.09967759924363498 +2.1159 0.7065373768913048 0.7065362129299895 1.0453651615172088e-07 -0.09967769702514935 +2.116 0.7065375514321801 0.7065363842730574 1.0569048938119385e-07 -0.09967779477705521 +2.1161 0.7065377259326043 0.7065365555517571 1.0680984267527616e-07 -0.09967789249936153 +2.1162 0.7065379003922189 0.706536726766479 1.078943285721945e-07 -0.09967799019207724 +2.1163000000000003 0.7065380748106623 0.7065368979176164 1.0894370771133421e-07 -0.09967808785521132 +2.1164 0.7065382491875707 0.7065370690055648 1.0995774887834209e-07 -0.09967818548877265 +2.1165 0.7065384235225776 0.7065372400307219 1.1093622907451528e-07 -0.09967828309277013 +2.1166 0.7065385978153146 0.7065374109934881 1.1187893356884304e-07 -0.09967838066721273 +2.1167000000000002 0.7065387720654107 0.7065375818942654 1.1278565595698731e-07 -0.09967847821210929 +2.1168 0.7065389462724936 0.706537752733459 1.1365619815087435e-07 -0.09967857572746885 +2.1169000000000002 0.7065391204361877 0.706537923511475 1.1449037046890043e-07 -0.09967867321330025 +2.117 0.7065392945561166 0.7065380942287222 1.1528799169144288e-07 -0.09967877066961245 +2.1170999999999998 0.7065394686319014 0.7065382648856104 1.1604888903310462e-07 -0.0996788680964143 +2.1172000000000004 0.7065396426631616 0.7065384354825519 1.1677289825026693e-07 -0.09967896549371469 +2.1173 0.7065398166495154 0.7065386060199603 1.1745986364108951e-07 -0.09967906286152259 +2.1174 0.7065399905905787 0.7065387764982514 1.1810963807673547e-07 -0.09967916019984692 +2.1175 0.7065401644859668 0.7065389469178411 1.1872208305341303e-07 -0.09967925750869651 +2.1176 0.7065403383352927 0.7065391172791481 1.19297068695845e-07 -0.09967935478808031 +2.1177 0.7065405121381689 0.7065392875825915 1.1983447380931045e-07 -0.09967945203800715 +2.1178000000000003 0.706540685894206 0.706539457828592 1.2033418588658362e-07 -0.09967954925848599 +2.1179 0.7065408596030143 0.7065396280175713 1.207961011495673e-07 -0.09967964644952569 +2.118 0.7065410332642024 0.7065397981499519 1.2122012454582332e-07 -0.09967974361113513 +2.1181 0.7065412068773779 0.7065399682261574 1.2160616978673655e-07 -0.09967984074332313 +2.1182000000000003 0.7065413804421485 0.7065401382466122 1.219541593579232e-07 -0.09967993784609869 +2.1183 0.7065415539581205 0.7065403082117415 1.2226402455392527e-07 -0.09968003491947061 +2.1184000000000003 0.7065417274248993 0.7065404781219713 1.2253570544004666e-07 -0.09968013196344784 +2.1185 0.7065419008420903 0.7065406479777272 1.2276915092868101e-07 -0.09968022897803917 +2.1186 0.7065420742092984 0.7065408177794363 1.2296431873420888e-07 -0.09968032596325348 +2.1187000000000005 0.7065422475261278 0.7065409875275257 1.2312117542156997e-07 -0.09968042291909968 +2.1188000000000002 0.7065424207921827 0.7065411572224225 1.2323969637850762e-07 -0.09968051984558661 +2.1189 0.7065425940070671 0.7065413268645544 1.233198658259771e-07 -0.09968061674272315 +2.119 0.7065427671703852 0.7065414964543486 1.2336167685284005e-07 -0.09968071361051814 +2.1191 0.7065429402817405 0.7065416659922328 1.2336513136035343e-07 -0.09968081044898044 +2.1192 0.7065431133407375 0.7065418354786339 1.2333024009686389e-07 -0.0996809072581189 +2.1193 0.7065432863469803 0.7065420049139792 1.2325702264046057e-07 -0.09968100403794236 +2.1194 0.7065434593000735 0.7065421742986957 1.2314550739897512e-07 -0.09968110078845971 +2.1195 0.7065436321996221 0.7065423436332097 1.2299573161692057e-07 -0.09968119750967977 +2.1195999999999997 0.706543805045232 0.7065425129179466 1.2280774127834682e-07 -0.09968129420161137 +2.1197000000000004 0.7065439778365088 0.706542682153332 1.2258159122133239e-07 -0.09968139086426336 +2.1198 0.7065441505730599 0.7065428513397902 1.2231734503043157e-07 -0.0996814874976446 +2.1199 0.7065443232544926 0.7065430204777452 1.220150750574911e-07 -0.0996815841017639 +2.12 0.7065444958804152 0.7065431895676194 1.2167486238348624e-07 -0.09968168067663007 +2.1201 0.7065446684504375 0.706543358609835 1.2129679680811245e-07 -0.09968177722225197 +2.1202 0.70654484096417 0.7065435276048129 1.2088097683243815e-07 -0.09968187373863849 +2.1203000000000003 0.7065450134212243 0.7065436965529723 1.2042750962767967e-07 -0.09968197022579833 +2.1204 0.7065451858212133 0.7065438654547318 1.199365110039763e-07 -0.0996820666837404 +2.1205 0.7065453581637513 0.7065440343105083 1.194081053618179e-07 -0.09968216311247348 +2.1206 0.7065455304484543 0.7065442031207174 1.1884242573714787e-07 -0.09968225951200642 +2.1207000000000003 0.7065457026749391 0.7065443718857731 1.1823961366605462e-07 -0.09968235588234799 +2.1208 0.7065458748428248 0.7065445406060877 1.1759981919171048e-07 -0.09968245222350701 +2.1209000000000002 0.7065460469517322 0.7065447092820719 1.1692320087824948e-07 -0.09968254853549231 +2.121 0.7065462190012834 0.7065448779141343 1.1620992568933675e-07 -0.09968264481831267 +2.1210999999999998 0.7065463909911028 0.7065450465026826 1.1546016899510736e-07 -0.09968274107197694 +2.1212000000000004 0.7065465629208166 0.7065452150481211 1.1467411451318577e-07 -0.09968283729649391 +2.1213 0.7065467347900534 0.7065453835508526 1.138519542878691e-07 -0.09968293349187235 +2.1214 0.7065469065984433 0.7065455520112782 1.1299388859992154e-07 -0.09968302965812109 +2.1215 0.7065470783456194 0.7065457204297961 1.1210012594575769e-07 -0.09968312579524888 +2.1216 0.7065472500312164 0.7065458888068025 1.1117088300968692e-07 -0.0996832219032645 +2.1217 0.7065474216548719 0.706546057142691 1.1020638454942167e-07 -0.0996833179821768 +2.1218000000000004 0.7065475932162261 0.7065462254378528 1.0920686339954688e-07 -0.09968341403199449 +2.1219 0.7065477647149214 0.7065463936926766 1.0817256039519219e-07 -0.09968351005272642 +2.122 0.7065479361506032 0.7065465619075479 1.0710372430264292e-07 -0.09968360604438135 +2.1221 0.7065481075229196 0.7065467300828504 1.0600061177423736e-07 -0.0996837020069681 +2.1222000000000003 0.7065482788315213 0.7065468982189635 1.0486348728244721e-07 -0.09968379794049533 +2.1223 0.7065484500760623 0.7065470663162652 1.0369262305048865e-07 -0.09968389384497192 +2.1224000000000003 0.7065486212561993 0.7065472343751296 1.0248829901415846e-07 -0.0996839897204066 +2.1225 0.7065487923715923 0.7065474023959277 1.0125080270387277e-07 -0.09968408556680813 +2.1226 0.7065489634219042 0.7065475703790276 9.998042922731987e-08 -0.09968418138418529 +2.1227000000000005 0.7065491344068014 0.706547738324794 9.867748117578512e-08 -0.09968427717254678 +2.1228000000000002 0.706549305325954 0.7065479062335883 9.734226853741479e-08 -0.09968437293190147 +2.1229 0.7065494761790346 0.7065480741057686 9.597510867639936e-08 -0.09968446866225805 +2.123 0.70654964696572 0.7065482419416889 9.457632619419565e-08 -0.09968456436362523 +2.1231 0.7065498176856905 0.7065484097417005 9.314625289136291e-08 -0.09968466003601185 +2.1232 0.7065499883386297 0.7065485775061504 9.168522766347942e-08 -0.09968475567942661 +2.1233 0.7065501589242251 0.7065487452353824 9.019359644216185e-08 -0.09968485129387827 +2.1234 0.7065503294421682 0.7065489129297358 8.867171213261527e-08 -0.09968494687937557 +2.1235 0.7065504998921541 0.7065490805895465 8.711993446444688e-08 -0.09968504243592723 +2.1235999999999997 0.706550670273882 0.7065492482151464 8.553862996737993e-08 -0.099685137963542 +2.1237000000000004 0.7065508405870549 0.7065494158068633 8.39281718619661e-08 -0.0996852334622286 +2.1238 0.7065510108313802 0.7065495833650213 8.228893997111464e-08 -0.09968532893199582 +2.1239 0.706551181006569 0.7065497508899395 8.062132064376448e-08 -0.09968542437285235 +2.124 0.7065513511123371 0.7065499183819333 7.892570663518839e-08 -0.09968551978480687 +2.1241 0.7065515211484046 0.7065500858413141 7.720249704974702e-08 -0.0996856151678682 +2.1242 0.7065516911144955 0.7065502532683883 7.545209720558055e-08 -0.09968571052204502 +2.1243000000000003 0.7065518610103385 0.7065504206634582 7.367491859991415e-08 -0.09968580584734603 +2.1244 0.7065520308356665 0.7065505880268215 7.18713787442593e-08 -0.09968590114377991 +2.1245 0.7065522005902178 0.7065507553587713 7.004190110890263e-08 -0.09968599641135546 +2.1246 0.7065523702737346 0.7065509226595967 6.818691501882246e-08 -0.09968609165008141 +2.1247000000000003 0.7065525398859634 0.7065510899295809 6.630685553919713e-08 -0.09968618685996636 +2.1248 0.7065527094266564 0.7065512571690036 6.440216338866878e-08 -0.09968628204101908 +2.1249000000000002 0.7065528788955698 0.7065514243781388 6.247328482138215e-08 -0.09968637719324827 +2.125 0.7065530482924656 0.7065515915572558 6.052067152637064e-08 -0.0996864723166626 +2.1250999999999998 0.7065532176171094 0.7065517587066199 5.8544780544289576e-08 -0.09968656741127085 +2.1252000000000004 0.7065533868692728 0.70655192582649 5.6546074128638324e-08 -0.09968666247708163 +2.1253 0.7065535560487319 0.706552092917121 5.452501964514633e-08 -0.09968675751410366 +2.1254 0.7065537251552684 0.7065522599787621 5.248208947115918e-08 -0.09968685252234567 +2.1255 0.7065538941886684 0.7065524270116579 5.0417760888085694e-08 -0.09968694750181634 +2.1256 0.7065540631487237 0.7065525940160473 4.833251596517152e-08 -0.09968704245252424 +2.1257 0.7065542320352312 0.7065527609921644 4.62268414502115e-08 -0.09968713737447817 +2.1258000000000004 0.7065544008479929 0.7065529279402376 4.4101228630771816e-08 -0.09968723226768678 +2.1259 0.7065545695868167 0.7065530948604903 4.1956173254392715e-08 -0.09968732713215876 +2.126 0.7065547382515152 0.7065532617531405 3.979217540195368e-08 -0.09968742196790276 +2.1261 0.7065549068419066 0.7065534286184006 3.760973936277334e-08 -0.09968751677492747 +2.1262000000000003 0.7065550753578147 0.7065535954564778 3.5409373528791366e-08 -0.09968761155324155 +2.1263 0.7065552437990686 0.7065537622675733 3.319159026099472e-08 -0.09968770630285367 +2.1264000000000003 0.7065554121655035 0.7065539290518832 3.0956905788803724e-08 -0.09968780102377252 +2.1265 0.7065555804569595 0.7065540958095978 2.8705840079967793e-08 -0.09968789571600675 +2.1266 0.7065557486732825 0.7065542625409018 2.643891671046117e-08 -0.09968799037956497 +2.1267000000000005 0.7065559168143243 0.7065544292459744 2.415666276213424e-08 -0.0996880850144559 +2.1268000000000002 0.7065560848799424 0.706554595924989 2.1859608680466214e-08 -0.09968817962068821 +2.1269 0.7065562528699995 0.7065547625781131 1.954828817048171e-08 -0.09968827419827049 +2.127 0.7065564207843644 0.7065549292055084 1.7223238067513857e-08 -0.09968836874721139 +2.1271 0.7065565886229122 0.706555095807331 1.4884998194956978e-08 -0.09968846326751957 +2.1272 0.706556756385523 0.7065552623837315 1.2534111264519976e-08 -0.09968855775920372 +2.1273 0.706556924072083 0.7065554289348537 1.0171122736581106e-08 -0.09968865222227241 +2.1274 0.7065570916824848 0.7065555954608362 7.796580692685795e-09 -0.09968874665673436 +2.1275 0.7065572592166262 0.7065557619618115 5.411035711513912e-09 -0.09968884106259811 +2.1275999999999997 0.7065574266744112 0.7065559284379064 3.0150407457144035e-09 -0.09968893543987235 +2.1277000000000004 0.7065575940557498 0.7065560948892414 6.091509822600538e-10 -0.0996890297885657 +2.1278 0.7065577613605583 0.706556261315931 -1.8060762720442658e-09 -0.09968912410868679 +2.1279 0.7065579285887584 0.7065564277180839 -4.230081730206836e-09 -0.09968921840024422 +2.128 0.7065580957402784 0.7065565940958027 -6.662304250816542e-09 -0.09968931266324668 +2.1281 0.7065582628150517 0.7065567604491838 -9.102180964677686e-09 -0.09968940689770273 +2.1282 0.7065584298130192 0.706556926778318 -1.1549147408383698e-08 -0.09968950110362101 +2.1283000000000003 0.7065585967341264 0.7065570930832894 -1.4002637660492923e-08 -0.09968959528101012 +2.1284 0.706558763578326 0.7065572593641763 -1.6462084462091908e-08 -0.09968968942987871 +2.1285 0.7065589303455763 0.7065574256210511 -1.8926919354705918e-08 -0.09968978355023539 +2.1286 0.7065590970358417 0.7065575918539793 -2.1396572806500064e-08 -0.0996898776420887 +2.1287000000000003 0.7065592636490926 0.7065577580630213 -2.38704743484551e-08 -0.09968997170544727 +2.1288 0.706559430185306 0.706557924248231 -2.6348052704038005e-08 -0.09969006574031977 +2.1289000000000002 0.7065595966444647 0.7065580904096558 -2.882873592104096e-08 -0.09969015974671475 +2.129 0.7065597630265578 0.7065582565473372 -3.1311951502552976e-08 -0.0996902537246408 +2.1290999999999998 0.7065599293315801 0.7065584226613104 -3.3797126542485165e-08 -0.0996903476741065 +2.1292000000000004 0.7065600955595333 0.7065585887516048 -3.6283687854699216e-08 -0.0996904415951205 +2.1293 0.7065602617104246 0.7065587548182437 -3.877106210712321e-08 -0.09969053548769138 +2.1294 0.7065604277842674 0.7065589208612433 -4.125867595006693e-08 -0.09969062935182765 +2.1295 0.706560593781082 0.7065590868806146 -4.3745956152994e-08 -0.09969072318753798 +2.1296 0.706560759700894 0.7065592528763622 -4.623232973443637e-08 -0.0996908169948309 +2.1297 0.7065609255437353 0.7065594188484845 -4.8717224094023057e-08 -0.09969091077371502 +2.1298000000000004 0.7065610913096441 0.7065595847969737 -5.120006714399387e-08 -0.09969100452419888 +2.1299 0.7065612569986649 0.7065597507218158 -5.368028744125522e-08 -0.09969109824629109 +2.13 0.7065614226108479 0.7065599166229908 -5.615731431913781e-08 -0.09969119194000019 +2.1301 0.7065615881462496 0.7065600825004725 -5.8630578019316926e-08 -0.09969128560533475 +2.1302000000000003 0.7065617536049329 0.706560248354229 -6.109950981877249e-08 -0.09969137924230337 +2.1303 0.7065619189869665 0.7065604141842219 -6.356354216672383e-08 -0.09969147285091462 +2.1304000000000003 0.706562084292425 0.7065605799904064 -6.602210881169815e-08 -0.09969156643117702 +2.1305 0.7065622495213892 0.7065607457727323 -6.847464492686431e-08 -0.09969165998309915 +2.1306 0.7065624146739462 0.7065609115311431 -7.092058725228015e-08 -0.09969175350668959 +2.1307000000000005 0.7065625797501889 0.7065610772655762 -7.335937421372105e-08 -0.09969184700195688 +2.1308000000000002 0.7065627447502159 0.7065612429759629 -7.579044605365154e-08 -0.09969194046890953 +2.1309 0.7065629096741322 0.7065614086622287 -7.82132449587275e-08 -0.0996920339075561 +2.131 0.7065630745220488 0.706561574324293 -8.06272151899004e-08 -0.0996921273179052 +2.1311 0.7065632392940825 0.7065617399620695 -8.303180321165421e-08 -0.09969222069996532 +2.1312 0.7065634039903557 0.7065619055754657 -8.542645781820651e-08 -0.09969231405374498 +2.1313 0.7065635686109972 0.7065620711643833 -8.781063025493918e-08 -0.09969240737925278 +2.1314 0.7065637331561415 0.7065622367287181 -9.018377434676789e-08 -0.09969250067649721 +2.1315 0.7065638976259285 0.7065624022683599 -9.254534662737901e-08 -0.09969259394548674 +2.1315999999999997 0.7065640620205045 0.7065625677831933 -9.489480645979292e-08 -0.09969268718622999 +2.1317000000000004 0.7065642263400211 0.7065627332730966 -9.723161615432518e-08 -0.09969278039873551 +2.1318 0.7065643905846364 0.7065628987379426 -9.95552411030276e-08 -0.09969287358301182 +2.1319 0.706564554754513 0.7065630641775984 -1.0186514989678208e-07 -0.09969296673906738 +2.132 0.70656471884982 0.7065632295919251 -1.0416081444759862e-07 -0.09969305986691077 +2.1321 0.7065648828707319 0.7065633949807782 -1.0644171010137232e-07 -0.09969315296655046 +2.1322 0.7065650468174289 0.7065635603440084 -1.0870731577232451e-07 -0.099693246037995 +2.1323000000000003 0.7065652106900966 0.7065637256814596 -1.1095711405229025e-07 -0.09969333908125287 +2.1324 0.706565374488926 0.7065638909929712 -1.1319059132867959e-07 -0.0996934320963326 +2.1325 0.7065655382141138 0.7065640562783768 -1.1540723790330609e-07 -0.0996935250832427 +2.1326 0.706565701865862 0.7065642215375045 -1.1760654811468485e-07 -0.09969361804199167 +2.1327000000000003 0.7065658654443779 0.706564386770177 -1.1978802044558534e-07 -0.09969371097258799 +2.1328 0.7065660289498743 0.7065645519762116 -1.2195115763752318e-07 -0.09969380387504018 +2.1329000000000002 0.7065661923825691 0.7065647171554206 -1.2409546679831296e-07 -0.09969389674935672 +2.133 0.7065663557426858 0.7065648823076112 -1.2622045953911143e-07 -0.09969398959554616 +2.1330999999999998 0.7065665190304526 0.7065650474325844 -1.283256520576842e-07 -0.09969408241361695 +2.1332000000000004 0.7065666822461032 0.7065652125301374 -1.3041056527024475e-07 -0.0996941752035776 +2.1333 0.7065668453898759 0.7065653776000612 -1.3247472488951695e-07 -0.09969426796543654 +2.1334 0.7065670084620146 0.7065655426421428 -1.345176615739213e-07 -0.09969436069920232 +2.1335 0.7065671714627679 0.7065657076561631 -1.365389109952292e-07 -0.09969445340488339 +2.1336 0.7065673343923893 0.706565872641899 -1.3853801397734067e-07 -0.09969454608248823 +2.1337 0.7065674972511369 0.7065660375991221 -1.4051451657261238e-07 -0.09969463873202532 +2.1338000000000004 0.7065676600392745 0.706566202527599 -1.4246797018502289e-07 -0.09969473135350315 +2.1339 0.7065678227570698 0.7065663674270922 -1.44397931662113e-07 -0.09969482394693023 +2.134 0.7065679854047953 0.7065665322973589 -1.4630396340080398e-07 -0.09969491651231494 +2.1341 0.7065681479827279 0.7065666971381519 -1.481856334341336e-07 -0.09969500904966576 +2.1342000000000003 0.7065683104911502 0.7065668619492196 -1.5004251554054382e-07 -0.09969510155899122 +2.1343 0.7065684729303479 0.7065670267303052 -1.5187418934969887e-07 -0.09969519404029974 +2.1344000000000003 0.706568635300612 0.7065671914811485 -1.5368024041881312e-07 -0.09969528649359977 +2.1345 0.7065687976022375 0.7065673562014843 -1.5546026032979554e-07 -0.09969537891889979 +2.1346 0.7065689598355239 0.7065675208910432 -1.5721384678292483e-07 -0.09969547131620829 +2.1347000000000005 0.7065691220007748 0.7065676855495511 -1.589406037026675e-07 -0.09969556368553362 +2.1348000000000003 0.706569284098298 0.7065678501767303 -1.606401412966585e-07 -0.09969565602688427 +2.1349 0.7065694461284053 0.706568014772299 -1.623120761753971e-07 -0.09969574834026869 +2.135 0.7065696080914129 0.706568179335971 -1.639560314251054e-07 -0.09969584062569534 +2.1351 0.7065697699876407 0.7065683438674565 -1.6557163668232122e-07 -0.09969593288317265 +2.1352 0.7065699318174126 0.7065685083664615 -1.6715852824145117e-07 -0.09969602511270909 +2.1353 0.7065700935810557 0.7065686728326885 -1.687163491050775e-07 -0.09969611731431308 +2.1354 0.7065702552789019 0.7065688372658359 -1.7024474908977627e-07 -0.09969620948799303 +2.1355 0.7065704169112862 0.7065690016655986 -1.7174338489550633e-07 -0.09969630163375741 +2.1355999999999997 0.7065705784785469 0.7065691660316675 -1.732119201975496e-07 -0.09969639375161458 +2.1357000000000004 0.7065707399810264 0.7065693303637307 -1.7465002568467503e-07 -0.099696485841573 +2.1358 0.7065709014190701 0.7065694946614725 -1.7605737916842612e-07 -0.0996965779036411 +2.1359 0.7065710627930271 0.7065696589245738 -1.7743366563516272e-07 -0.0996966699378273 +2.136 0.7065712241032494 0.706569823152712 -1.7877857734147073e-07 -0.09969676194414002 +2.1361 0.706571385350093 0.7065699873455616 -1.8009181384365247e-07 -0.09969685392258767 +2.1362 0.7065715465339163 0.706570151502794 -1.8137308210527947e-07 -0.09969694587317873 +2.1363000000000003 0.7065717076550808 0.7065703156240773 -1.8262209652841754e-07 -0.09969703779592155 +2.1364 0.7065718687139508 0.7065704797090767 -1.8383857904036294e-07 -0.09969712969082452 +2.1365 0.7065720297108944 0.7065706437574544 -1.850222591422146e-07 -0.09969722155789607 +2.1366 0.7065721906462814 0.7065708077688702 -1.8617287399561033e-07 -0.0996973133971446 +2.1367000000000003 0.706572351520485 0.7065709717429807 -1.8729016844007407e-07 -0.0996974052085785 +2.1368 0.7065725123338806 0.70657113567944 -1.883738950658742e-07 -0.09969749699220617 +2.1369000000000002 0.7065726730868469 0.7065712995778998 -1.894238142764737e-07 -0.09969758874803603 +2.137 0.706572833779764 0.7065714634380091 -1.9043969435098007e-07 -0.09969768047607645 +2.1370999999999998 0.7065729944130155 0.7065716272594146 -1.9142131146149266e-07 -0.09969777217633582 +2.1372000000000004 0.7065731549869865 0.7065717910417606 -1.923684497598388e-07 -0.09969786384882257 +2.1373 0.7065733155020646 0.7065719547846894 -1.9328090139492105e-07 -0.09969795549354503 +2.1374 0.7065734759586395 0.7065721184878411 -1.9415846657863667e-07 -0.09969804711051163 +2.1375 0.7065736363571029 0.7065722821508535 -1.9500095361363323e-07 -0.09969813869973072 +2.1376 0.7065737966978487 0.7065724457733626 -1.9580817895575864e-07 -0.0996982302612107 +2.1377 0.7065739569812723 0.7065726093550029 -1.9657996721406112e-07 -0.09969832179495997 +2.1378000000000004 0.706574117207771 0.7065727728954063 -1.9731615124793378e-07 -0.0996984133009868 +2.1379 0.7065742773777439 0.7065729363942036 -1.9801657214282842e-07 -0.09969850477929967 +2.138 0.7065744374915914 0.706573099851024 -1.986810792935223e-07 -0.0996985962299069 +2.1381 0.7065745975497161 0.7065732632654949 -1.9930953041105703e-07 -0.09969868765281685 +2.1382000000000003 0.7065747575525213 0.7065734266372423 -1.999017915470247e-07 -0.09969877904803792 +2.1383 0.7065749175004118 0.7065735899658909 -2.004577371352012e-07 -0.0996988704155784 +2.1384000000000003 0.7065750773937935 0.7065737532510646 -2.0097725002277134e-07 -0.0996989617554467 +2.1385 0.7065752372330744 0.7065739164923857 -2.014602214772676e-07 -0.09969905306765117 +2.1386 0.7065753970186623 0.7065740796894752 -2.0190655122473422e-07 -0.09969914435220022 +2.1387000000000005 0.7065755567509666 0.7065742428419535 -2.0231614746707427e-07 -0.09969923560910206 +2.1388000000000003 0.7065757164303973 0.7065744059494401 -2.0268892688204976e-07 -0.09969932683836517 +2.1389 0.7065758760573657 0.7065745690115537 -2.0302481468573164e-07 -0.09969941803999784 +2.139 0.706576035632283 0.7065747320279121 -2.03323744587397e-07 -0.09969950921400839 +2.1391 0.7065761951555619 0.7065748949981328 -2.0358565884157076e-07 -0.09969960036040519 +2.1392 0.7065763546276149 0.7065750579218324 -2.0381050825149516e-07 -0.09969969147919659 +2.1393 0.7065765140488555 0.7065752207986274 -2.0399825217259915e-07 -0.09969978257039094 +2.1394 0.7065766734196968 0.7065753836281339 -2.0414885852290676e-07 -0.09969987363399652 +2.1395 0.7065768327405525 0.7065755464099672 -2.0426230380038435e-07 -0.09969996467002164 +2.1395999999999997 0.706576992011837 0.7065757091437439 -2.04338573055185e-07 -0.09970005567847473 +2.1397000000000004 0.7065771512339638 0.7065758718290787 -2.0437765991393464e-07 -0.09970014665936405 +2.1398 0.706577310407347 0.706576034465588 -2.043795665797321e-07 -0.09970023761269797 +2.1399 0.7065774695324002 0.706576197052887 -2.0434430380092405e-07 -0.09970032853848475 +2.14 0.7065776286095371 0.7065763595905916 -2.042718908953911e-07 -0.09970041943673275 +2.1401 0.7065777876391708 0.7065765220783184 -2.0416235575748676e-07 -0.09970051030745022 +2.1402 0.706577946621714 0.7065766845156841 -2.0401573480599566e-07 -0.09970060115064558 +2.1403000000000003 0.706578105557579 0.7065768469023056 -2.0383207298760309e-07 -0.09970069196632703 +2.1404 0.7065782644471778 0.706577009237801 -2.036114237838338e-07 -0.09970078275450295 +2.1405 0.7065784232909212 0.7065771715217883 -2.033538491937048e-07 -0.09970087351518164 +2.1406 0.7065785820892194 0.706577333753887 -2.0305941968862262e-07 -0.09970096424837138 +2.1407000000000003 0.7065787408424822 0.706577495933717 -2.027282142054443e-07 -0.09970105495408046 +2.1408 0.7065788995511173 0.7065776580608993 -2.0236032014300798e-07 -0.09970114563231722 +2.1409000000000002 0.7065790582155327 0.7065778201350561 -2.0195583332396905e-07 -0.09970123628308993 +2.141 0.7065792168361344 0.7065779821558102 -2.0151485797745283e-07 -0.09970132690640687 +2.1411 0.7065793754133275 0.7065781441227863 -2.010375067008907e-07 -0.09970141750227633 +2.1412000000000004 0.7065795339475156 0.7065783060356101 -2.0052390045308122e-07 -0.09970150807070664 +2.1413 0.706579692439101 0.7065784678939087 -1.999741684778622e-07 -0.09970159861170604 +2.1414 0.7065798508884847 0.7065786296973104 -1.993884483526831e-07 -0.09970168912528286 +2.1415 0.7065800092960656 0.7065787914454458 -1.9876688587411317e-07 -0.09970177961144533 +2.1416 0.7065801676622416 0.7065789531379463 -1.9810963505784152e-07 -0.0997018700702018 +2.1417 0.7065803259874082 0.7065791147744455 -1.9741685810398257e-07 -0.09970196050156045 +2.1418000000000004 0.7065804842719594 0.7065792763545788 -1.9668872534503445e-07 -0.09970205090552961 +2.1419 0.7065806425162873 0.7065794378779837 -1.9592541520424556e-07 -0.09970214128211755 +2.142 0.7065808007207818 0.7065795993442994 -1.9512711416438955e-07 -0.09970223163133252 +2.1421 0.7065809588858307 0.7065797607531674 -1.9429401671572366e-07 -0.0997023219531828 +2.1422000000000003 0.7065811170118199 0.7065799221042315 -1.934263252970081e-07 -0.09970241224767665 +2.1423 0.7065812750991329 0.7065800833971372 -1.9252425027815878e-07 -0.09970250251482236 +2.1424000000000003 0.7065814331481505 0.706580244631533 -1.9158800985963342e-07 -0.09970259275462816 +2.1425 0.7065815911592512 0.7065804058070693 -1.9061783006896205e-07 -0.09970268296710226 +2.1426 0.7065817491328115 0.7065805669233995 -1.8961394468094972e-07 -0.09970277315225298 +2.1427000000000005 0.7065819070692047 0.7065807279801792 -1.8857659516563485e-07 -0.09970286331008854 +2.1428000000000003 0.7065820649688015 0.7065808889770673 -1.8750603063277804e-07 -0.09970295344061725 +2.1429 0.7065822228319698 0.7065810499137244 -1.8640250777982037e-07 -0.09970304354384725 +2.143 0.7065823806590752 0.706581210789815 -1.8526629079473889e-07 -0.09970313361978686 +2.1431 0.7065825384504796 0.7065813716050058 -1.8409765133522993e-07 -0.0997032236684443 +2.1432 0.7065826962065421 0.7065815323589668 -1.8289686845585074e-07 -0.09970331368982778 +2.1433 0.7065828539276192 0.7065816930513715 -1.8166422852822217e-07 -0.0997034036839456 +2.1434 0.7065830116140636 0.7065818536818961 -1.8040002517163978e-07 -0.09970349365080595 +2.1435 0.7065831692662249 0.7065820142502195 -1.7910455920797097e-07 -0.09970358359041705 +2.1435999999999997 0.7065833268844497 0.706582174756025 -1.7777813855063274e-07 -0.09970367350278717 +2.1437000000000004 0.706583484469081 0.7065823351989986 -1.7642107815948882e-07 -0.09970376338792449 +2.1438 0.7065836420204582 0.7065824955788299 -1.750336999714608e-07 -0.09970385324583725 +2.1439 0.7065837995389175 0.706582655895212 -1.7361633279644462e-07 -0.09970394307653366 +2.144 0.706583957024791 0.706582816147842 -1.7216931227047316e-07 -0.099704032880022 +2.1441 0.7065841144784075 0.7065829763364202 -1.706929807325508e-07 -0.09970412265631046 +2.1442 0.7065842719000919 0.7065831364606507 -1.6918768721251032e-07 -0.09970421240540718 +2.1443000000000003 0.7065844292901651 0.7065832965202417 -1.6765378728182678e-07 -0.09970430212732041 +2.1444 0.7065845866489446 0.7065834565149051 -1.6609164300331047e-07 -0.09970439182205845 +2.1445 0.7065847439767434 0.7065836164443569 -1.6450162284610548e-07 -0.0997044814896294 +2.1446 0.7065849012738707 0.7065837763083169 -1.6288410158160627e-07 -0.09970457113004154 +2.1447000000000003 0.7065850585406315 0.7065839361065092 -1.6123946021233404e-07 -0.099704660743303 +2.1448 0.7065852157773265 0.706584095838662 -1.5956808586264914e-07 -0.099704750329422 +2.1449000000000003 0.7065853729842528 0.7065842555045072 -1.5787037172670937e-07 -0.09970483988840673 +2.145 0.7065855301617026 0.7065844151037826 -1.5614671692275317e-07 -0.09970492942026543 +2.1451 0.7065856873099636 0.7065845746362281 -1.543975264358538e-07 -0.09970501892500624 +2.1452000000000004 0.7065858444293196 0.7065847341015898 -1.526232110051623e-07 -0.09970510840263738 +2.1453 0.7065860015200498 0.7065848934996176 -1.5082418705798795e-07 -0.09970519785316703 +2.1454 0.7065861585824285 0.706585052830066 -1.4900087657795935e-07 -0.09970528727660335 +2.1455 0.7065863156167256 0.706585212092694 -1.4715370700614516e-07 -0.09970537667295457 +2.1456 0.7065864726232067 0.7065853712872654 -1.4528311117339987e-07 -0.09970546604222885 +2.1457 0.7065866296021321 0.7065855304135484 -1.433895271667901e-07 -0.09970555538443435 +2.1458000000000004 0.7065867865537578 0.7065856894713165 -1.414733982324501e-07 -0.09970564469957927 +2.1459 0.7065869434783345 0.7065858484603476 -1.3953517268364135e-07 -0.09970573398767174 +2.146 0.7065871003761084 0.7065860073804244 -1.3757530379493454e-07 -0.09970582324871996 +2.1461 0.7065872572473209 0.7065861662313351 -1.3559424969292189e-07 -0.09970591248273214 +2.1462000000000003 0.7065874140922078 0.7065863250128719 -1.3359247323652124e-07 -0.09970600168971637 +2.1463 0.7065875709110006 0.706586483724833 -1.3157044193197465e-07 -0.09970609086968085 +2.1464000000000003 0.7065877277039248 0.7065866423670213 -1.2952862780794827e-07 -0.0997061800226337 +2.1465 0.7065878844712019 0.7065868009392446 -1.274675073079795e-07 -0.09970626914858315 +2.1466 0.7065880412130476 0.7065869594413161 -1.253875611863936e-07 -0.0997063582475373 +2.1467 0.7065881979296722 0.7065871178730543 -1.232892743799341e-07 -0.09970644731950427 +2.1468000000000003 0.7065883546212812 0.7065872762342825 -1.2117313591755718e-07 -0.0997065363644923 +2.1469 0.7065885112880743 0.70658743452483 -1.190396387885928e-07 -0.09970662538250948 +2.147 0.7065886679302466 0.7065875927445306 -1.1688927982998754e-07 -0.09970671437356399 +2.1471 0.7065888245479868 0.7065877508932245 -1.1472255962395594e-07 -0.09970680333766391 +2.1472 0.7065889811414791 0.7065879089707561 -1.1253998236267215e-07 -0.09970689227481742 +2.1473 0.7065891377109019 0.7065880669769762 -1.1034205575286005e-07 -0.09970698118503266 +2.1474 0.706589294256428 0.7065882249117408 -1.0812929087528067e-07 -0.0997070700683178 +2.1475 0.7065894507782248 0.7065883827749112 -1.0590220207631201e-07 -0.0997071589246809 +2.1475999999999997 0.7065896072764537 0.7065885405663548 -1.0366130685172253e-07 -0.09970724775413015 +2.1477000000000004 0.7065897637512715 0.706588698285944 -1.0140712572090371e-07 -0.09970733655667367 +2.1478 0.7065899202028283 0.7065888559335569 -9.914018211064357e-08 -0.09970742533231954 +2.1479 0.7065900766312692 0.7065890135090778 -9.686100223022659e-08 -0.09970751408107592 +2.148 0.7065902330367333 0.7065891710123959 -9.457011494479889e-08 -0.09970760280295093 +2.1481 0.7065903894193543 0.7065893284434068 -9.226805166781538e-08 -0.09970769149795271 +2.1482 0.7065905457792596 0.7065894858020112 -8.995534622226187e-08 -0.09970778016608933 +2.1483000000000003 0.7065907021165716 0.7065896430881162 -8.763253472182653e-08 -0.0997078688073689 +2.1484 0.7065908584314062 0.7065898003016342 -8.53001554477345e-08 -0.0997079574217996 +2.1485 0.7065910147238739 0.7065899574424837 -8.295874872818465e-08 -0.09970804600938944 +2.1486 0.7065911709940792 0.7065901145105885 -8.060885680304108e-08 -0.0997081345701466 +2.1487000000000003 0.7065913272421211 0.7065902715058789 -7.825102371020881e-08 -0.0997082231040792 +2.1488 0.7065914834680924 0.7065904284282907 -7.588579515206001e-08 -0.09970831161119527 +2.1489000000000003 0.7065916396720797 0.7065905852777654 -7.351371836966658e-08 -0.0997084000915029 +2.149 0.7065917958541643 0.7065907420542511 -7.113534201573166e-08 -0.09970848854501026 +2.1491 0.7065919520144215 0.706590898757701 -6.875121603229159e-08 -0.09970857697172542 +2.1492000000000004 0.7065921081529205 0.7065910553880745 -6.636189151931066e-08 -0.09970866537165646 +2.1493 0.7065922642697245 0.7065912119453375 -6.3967920611082e-08 -0.09970875374481147 +2.1494 0.7065924203648907 0.7065913684294605 -6.156985634525602e-08 -0.09970884209119846 +2.1495 0.7065925764384708 0.7065915248404215 -5.916825253447083e-08 -0.0997089304108257 +2.1496 0.7065927324905104 0.7065916811782034 -5.6763663642970044e-08 -0.09970901870370112 +2.1497 0.7065928885210486 0.7065918374427951 -5.435664465346275e-08 -0.09970910696983284 +2.1498000000000004 0.7065930445301192 0.7065919936341922 -5.194775094395816e-08 -0.09970919520922897 +2.1499 0.7065932005177498 0.7065921497523954 -4.953753815690239e-08 -0.09970928342189755 +2.15 0.7065933564839619 0.7065923057974117 -4.712656207015841e-08 -0.09970937160784667 +2.1501 0.7065935124287711 0.7065924617692545 -4.4715378471834894e-08 -0.0997094597670844 +2.1502000000000003 0.7065936683521872 0.7065926176679422 -4.230454303099512e-08 -0.09970954789961878 +2.1503 0.7065938242542136 0.7065927734935001 -3.989461116714614e-08 -0.09970963600545789 +2.1504000000000003 0.7065939801348481 0.706592929245959 -3.748613792617893e-08 -0.09970972408460978 +2.1505 0.7065941359940825 0.7065930849253554 -3.507967785069781e-08 -0.0997098121370825 +2.1506 0.7065942918319026 0.7065932405317324 -3.267578485110882e-08 -0.09970990016288415 +2.1507 0.7065944476482886 0.7065933960651387 -3.027501208258988e-08 -0.0997099881620228 +2.1508000000000003 0.706594603443214 0.7065935515256289 -2.7877911812357326e-08 -0.09971007613450641 +2.1509 0.706594759216647 0.7065937069132633 -2.5485035295633174e-08 -0.09971016408034315 +2.151 0.7065949149685498 0.7065938622281085 -2.309693264814297e-08 -0.09971025199954098 +2.1511 0.7065950706988784 0.7065940174702368 -2.0714152723384088e-08 -0.09971033989210792 +2.1512000000000002 0.7065952264075832 0.7065941726397262 -1.8337242978401502e-08 -0.09971042775805211 +2.1513 0.7065953820946087 0.7065943277366611 -1.5966749356693954e-08 -0.09971051559738152 +2.1514 0.7065955377598936 0.7065944827611309 -1.3603216157242332e-08 -0.09971060341010421 +2.1515 0.7065956934033707 0.7065946377132317 -1.1247185910043256e-08 -0.09971069119622822 +2.1515999999999997 0.7065958490249669 0.7065947925930649 -8.899199255979484e-09 -0.09971077895576158 +2.1517000000000004 0.7065960046246036 0.7065949474007378 -6.559794818450371e-09 -0.09971086668871237 +2.1518 0.7065961602021962 0.7065951021363631 -4.229509082374905e-09 -0.09971095439508856 +2.1519 0.7065963157576542 0.70659525680006 -1.9088762636537693e-09 -0.09971104207489818 +2.152 0.7065964712908819 0.7065954113919524 4.015717957814302e-10 -0.09971112972814926 +2.1521 0.7065966268017774 0.7065955659121708 2.701305769348128e-09 -0.09971121735484981 +2.1522 0.7065967822902335 0.7065957203608508 4.989798957702463e-09 -0.09971130495500785 +2.1523000000000003 0.7065969377561374 0.7065958747381339 7.266527405833112e-09 -0.09971139252863147 +2.1524 0.7065970931993704 0.7065960290441669 9.530970030563468e-09 -0.09971148007572855 +2.1525 0.7065972486198082 0.7065961832791021 1.1782608737645472e-08 -0.09971156759630717 +2.1526 0.7065974040173213 0.7065963374430982 1.4020928532781918e-08 -0.09971165509037538 +2.1527000000000003 0.7065975593917748 0.7065964915363183 1.624541765780224e-08 -0.09971174255794117 +2.1528 0.706597714743028 0.7065966455589314 1.8455567686072316e-08 -0.09971182999901251 +2.1529000000000003 0.7065978700709349 0.706596799511112 2.0650873649129264e-08 -0.09971191741359745 +2.153 0.7065980253753439 0.7065969533930395 2.2830834150305845e-08 -0.09971200480170388 +2.1531 0.7065981806560986 0.7065971072048994 2.4994951483559014e-08 -0.09971209216333993 +2.1532000000000004 0.7065983359130366 0.7065972609468818 2.7142731741022774e-08 -0.09971217949851352 +2.1533 0.7065984911459909 0.7065974146191825 2.9273684927499932e-08 -0.09971226680723268 +2.1534 0.706598646354789 0.7065975682220023 3.1387325075821204e-08 -0.09971235408950536 +2.1535 0.706598801539253 0.706597721755547 3.34831703491939e-08 -0.09971244134533958 +2.1536 0.7065989566992001 0.7065978752200279 3.556074315742841e-08 -0.09971252857474328 +2.1537 0.7065991118344428 0.7065980286156611 3.761957027489937e-08 -0.0997126157777245 +2.1538000000000004 0.706599266944788 0.7065981819426678 3.9659182925547154e-08 -0.09971270295429117 +2.1539 0.706599422030038 0.7065983352012742 4.16791169060432e-08 -0.09971279010445137 +2.154 0.7065995770899898 0.7065984883917115 4.367891268119983e-08 -0.09971287722821298 +2.1541 0.7065997321244355 0.7065986415142154 4.565811551060506e-08 -0.09971296432558398 +2.1542000000000003 0.7065998871331628 0.7065987945690269 4.761627551974623e-08 -0.09971305139657233 +2.1543 0.7066000421159544 0.7065989475563914 4.95529478283796e-08 -0.09971313844118607 +2.1544 0.7066001970725885 0.7065991004765593 5.146769263553175e-08 -0.09971322545943309 +2.1545 0.7066003520028381 0.7065992533297853 5.336007533225662e-08 -0.0997133124513214 +2.1546 0.706600506906472 0.706599406116329 5.52296665814328e-08 -0.09971339941685892 +2.1547 0.7066006617832546 0.7065995588364545 5.707604244266362e-08 -0.09971348635605366 +2.1548000000000003 0.7066008166329455 0.7065997114904303 5.889878443993135e-08 -0.09971357326891354 +2.1549 0.7066009714552998 0.7065998640785291 6.069747967261951e-08 -0.09971366015544653 +2.155 0.7066011262500687 0.7066000166010284 6.247172090224906e-08 -0.09971374701566058 +2.1551 0.7066012810169984 0.70660016905821 6.422110666350067e-08 -0.09971383384956362 +2.1552000000000002 0.7066014357558315 0.7066003214503596 6.594524132493007e-08 -0.0997139206571636 +2.1553 0.7066015904663061 0.706600473777767 6.764373519305145e-08 -0.09971400743846853 +2.1554 0.7066017451481565 0.7066006260407263 6.931620460601251e-08 -0.09971409419348627 +2.1555 0.7066018998011123 0.7066007782395358 7.096227201339178e-08 -0.09971418092222481 +2.1555999999999997 0.7066020544248999 0.7066009303744976 7.258156605252641e-08 -0.09971426762469204 +2.1557000000000004 0.7066022090192411 0.7066010824459177 7.417372165953451e-08 -0.09971435430089592 +2.1558 0.7066023635838545 0.7066012344541059 7.573838011268319e-08 -0.09971444095084442 +2.1559 0.7066025181184545 0.7066013863993759 7.727518915381926e-08 -0.09971452757454542 +2.156 0.7066026726227519 0.7066015382820447 7.878380303867616e-08 -0.09971461417200687 +2.1561 0.7066028270964537 0.7066016901024338 8.02638826253449e-08 -0.09971470074323668 +2.1562 0.7066029815392636 0.7066018418608674 8.171509545754074e-08 -0.09971478728824282 +2.1563000000000003 0.7066031359508818 0.7066019935576734 8.313711581491023e-08 -0.09971487380703314 +2.1564 0.7066032903310048 0.7066021451931832 8.452962480670623e-08 -0.0997149602996156 +2.1565 0.706603444679326 0.7066022967677315 8.589231044811574e-08 -0.09971504676599807 +2.1566 0.7066035989955355 0.7066024482816563 8.722486771924054e-08 -0.09971513320618852 +2.1567000000000003 0.7066037532793203 0.7066025997352989 8.852699862407776e-08 -0.09971521962019486 +2.1568 0.7066039075303644 0.7066027511290034 8.979841227552132e-08 -0.09971530600802497 +2.1569000000000003 0.7066040617483481 0.7066029024631173 9.103882495087312e-08 -0.0997153923696868 +2.157 0.7066042159329493 0.7066030537379907 9.224796014214998e-08 -0.0997154787051882 +2.1571 0.7066043700838429 0.7066032049539769 9.342554866190178e-08 -0.0997155650145371 +2.1572000000000005 0.706604524200701 0.7066033561114315 9.457132866749762e-08 -0.0997156512977414 +2.1573 0.706604678283193 0.7066035072107133 9.568504568888136e-08 -0.099715737554809 +2.1574 0.7066048323309855 0.7066036582521836 9.676645275694118e-08 -0.09971582378574777 +2.1575 0.7066049863437427 0.7066038092362061 9.781531042432623e-08 -0.09971590999056558 +2.1576 0.7066051403211265 0.7066039601631472 9.88313867966717e-08 -0.09971599616927039 +2.1577 0.7066052942627958 0.7066041110333754 9.981445759504881e-08 -0.09971608232187001 +2.1578000000000004 0.7066054481684081 0.7066042618472621 1.007643062392316e-07 -0.09971616844837243 +2.1579 0.7066056020376174 0.7066044126051804 1.0168072386504412e-07 -0.09971625454878542 +2.158 0.7066057558700769 0.7066045633075055 1.0256350936599379e-07 -0.09971634062311696 +2.1581 0.7066059096654368 0.7066047139546148 1.0341246945919091e-07 -0.09971642667137487 +2.1582000000000003 0.7066060634233458 0.7066048645468879 1.0422741869228758e-07 -0.09971651269356702 +2.1583 0.7066062171434502 0.7066050150847061 1.050081795232749e-07 -0.09971659868970134 +2.1584 0.7066063708253953 0.7066051655684522 1.057545823378303e-07 -0.09971668465978566 +2.1585 0.7066065244688238 0.7066053159985111 1.0646646550135919e-07 -0.09971677060382778 +2.1586 0.7066066780733775 0.7066054663752692 1.0714367535205604e-07 -0.09971685652183568 +2.1587 0.7066068316386961 0.7066056166991146 1.077860662841712e-07 -0.09971694241381718 +2.1588000000000003 0.706606985164418 0.7066057669704371 1.0839350076882748e-07 -0.09971702827978018 +2.1589 0.7066071386501802 0.7066059171896268 1.0896584935748965e-07 -0.09971711411973244 +2.159 0.7066072920956187 0.7066060673570762 1.0950299073400616e-07 -0.09971719993368192 +2.1591 0.7066074455003678 0.7066062174731785 1.1000481171807852e-07 -0.0997172857216364 +2.1592000000000002 0.706607598864061 0.7066063675383281 1.1047120733118088e-07 -0.09971737148360377 +2.1593 0.706607752186331 0.7066065175529206 1.1090208076186547e-07 -0.09971745721959188 +2.1594 0.7066079054668088 0.706606667517352 1.1129734342474329e-07 -0.09971754292960859 +2.1595 0.7066080587051253 0.7066068174320199 1.1165691497089236e-07 -0.09971762861366168 +2.1595999999999997 0.7066082119009102 0.7066069672973221 1.1198072329132724e-07 -0.09971771427175906 +2.1597000000000004 0.7066083650537929 0.7066071171136572 1.1226870455169347e-07 -0.09971779990390857 +2.1598 0.7066085181634016 0.7066072668814245 1.1252080317145086e-07 -0.09971788551011804 +2.1599 0.7066086712293649 0.7066074166010236 1.1273697188285414e-07 -0.09971797109039526 +2.16 0.7066088242513098 0.7066075662728546 1.1291717169278903e-07 -0.09971805664474809 +2.1601 0.7066089772288642 0.7066077158973181 1.1306137191052779e-07 -0.09971814217318438 +2.1602 0.706609130161655 0.7066078654748145 1.1316955015813757e-07 -0.09971822767571198 +2.1603000000000003 0.7066092830493094 0.7066080150057448 1.1324169236354154e-07 -0.09971831315233867 +2.1604 0.7066094358914539 0.7066081644905096 1.1327779275704941e-07 -0.09971839860307229 +2.1605 0.706609588687716 0.7066083139295096 1.1327785387829636e-07 -0.09971848402792065 +2.1606 0.7066097414377224 0.7066084633231458 1.1324188656930412e-07 -0.09971856942689156 +2.1607000000000003 0.7066098941411003 0.7066086126718182 1.1316990998141985e-07 -0.09971865479999287 +2.1608 0.7066100467974777 0.7066087619759271 1.130619515544995e-07 -0.09971874014723237 +2.1609000000000003 0.7066101994064824 0.7066089112358722 1.1291804699956054e-07 -0.09971882546861788 +2.161 0.7066103519677429 0.7066090604520529 1.1273824029878199e-07 -0.09971891076415723 +2.1611 0.7066105044808881 0.7066092096248673 1.1252258371591273e-07 -0.09971899603385816 +2.1612000000000005 0.7066106569455481 0.706609358754714 1.1227113775463815e-07 -0.09971908127772856 +2.1613 0.706610809361353 0.7066095078419896 1.1198397113776348e-07 -0.09971916649577617 +2.1614 0.7066109617279343 0.7066096568870908 1.1166116079333599e-07 -0.09971925168800883 +2.1615 0.7066111140449242 0.706609805890413 1.1130279186158387e-07 -0.09971933685443435 +2.1616 0.7066112663119558 0.7066099548523503 1.1090895763940511e-07 -0.09971942199506045 +2.1617 0.7066114185286635 0.7066101037732966 1.1047975956302025e-07 -0.09971950710989498 +2.1618000000000004 0.7066115706946828 0.7066102526536437 1.1001530719409458e-07 -0.09971959219894574 +2.1619 0.7066117228096507 0.7066104014937824 1.0951571817463535e-07 -0.09971967726222053 +2.162 0.7066118748732049 0.7066105502941022 1.0898111822699175e-07 -0.09971976229972707 +2.1620999999999997 0.7066120268849853 0.706610699054991 1.0841164110181323e-07 -0.09971984731147318 +2.1622000000000003 0.7066121788446331 0.7066108477768355 1.0780742852600778e-07 -0.09971993229746667 +2.1623 0.7066123307517909 0.7066109964600203 1.0716863019233358e-07 -0.09972001725771529 +2.1624 0.7066124826061028 0.7066111451049286 1.0649540374899069e-07 -0.09972010219222677 +2.1625 0.7066126344072156 0.706611293711942 1.0578791468512927e-07 -0.099720187101009 +2.1626 0.706612786154777 0.7066114422814396 1.0504633637248295e-07 -0.09972027198406963 +2.1627 0.7066129378484372 0.7066115908137991 1.0427084997516323e-07 -0.0997203568414165 +2.1628000000000003 0.7066130894878484 0.706611739309396 1.0346164441496497e-07 -0.09972044167305741 +2.1629 0.7066132410726644 0.7066118877686035 1.0261891631585529e-07 -0.09972052647900004 +2.163 0.7066133926025424 0.7066120361917927 1.017428699727485e-07 -0.09972061125925222 +2.1631 0.7066135440771403 0.7066121845793325 1.0083371731334223e-07 -0.09972069601382166 +2.1632000000000002 0.7066136954961193 0.7066123329315895 9.989167781485064e-08 -0.09972078074271618 +2.1633 0.7066138468591432 0.7066124812489275 9.891697847277947e-08 -0.09972086544594344 +2.1634 0.7066139981658777 0.7066126295317081 9.790985373847594e-08 -0.0997209501235113 +2.1635 0.7066141494159915 0.70661277778029 9.687054545667872e-08 -0.09972103477542746 +2.1635999999999997 0.7066143006091561 0.7066129259950296 9.579930285164018e-08 -0.09972111940169966 +2.1637000000000004 0.7066144517450454 0.7066130741762799 9.469638237794009e-08 -0.09972120400233565 +2.1638 0.7066146028233364 0.7066132223243918 9.356204774130239e-08 -0.09972128857734319 +2.1639 0.7066147538437089 0.706613370439713 9.239656981879785e-08 -0.09972137312673005 +2.164 0.7066149048058457 0.7066135185225877 9.120022655823012e-08 -0.0997214576505039 +2.1641 0.7066150557094326 0.7066136665733578 8.997330295384964e-08 -0.09972154214867253 +2.1642 0.7066152065541585 0.7066138145923617 8.871609094920907e-08 -0.09972162662124365 +2.1643000000000003 0.706615357339716 0.7066139625799344 8.742888938512161e-08 -0.09972171106822499 +2.1644 0.7066155080658005 0.7066141105364079 8.611200393374152e-08 -0.09972179548962429 +2.1645 0.7066156587321111 0.7066142584621105 8.476574699274597e-08 -0.09972187988544928 +2.1646 0.7066158093383496 0.7066144063573674 8.339043764543641e-08 -0.09972196425570769 +2.1647000000000003 0.7066159598842221 0.7066145542225003 8.198640158788018e-08 -0.09972204860040723 +2.1648 0.7066161103694382 0.7066147020578271 8.055397102309236e-08 -0.09972213291955566 +2.1649000000000003 0.7066162607937108 0.7066148498636621 7.909348458817744e-08 -0.09972221721316066 +2.165 0.7066164111567561 0.7066149976403159 7.760528730055283e-08 -0.09972230148122992 +2.1651 0.7066165614582955 0.7066151453880956 7.608973045386547e-08 -0.09972238572377125 +2.1652000000000005 0.706616711698053 0.7066152931073035 7.454717153992929e-08 -0.09972246994079229 +2.1653000000000002 0.7066168618757567 0.7066154407982393 7.297797417586682e-08 -0.09972255413230073 +2.1654 0.7066170119911391 0.7066155884611978 7.138250798614798e-08 -0.09972263829830433 +2.1655 0.7066171620439365 0.70661573609647 6.976114856616089e-08 -0.09972272243881075 +2.1656 0.7066173120338891 0.7066158837043427 6.811427733476039e-08 -0.0997228065538277 +2.1657 0.7066174619607417 0.7066160312850989 6.644228148396103e-08 -0.09972289064336293 +2.1658000000000004 0.7066176118242427 0.7066161788390171 6.474555390260928e-08 -0.09972297470742407 +2.1659 0.7066177616241456 0.7066163263663713 6.30244930306667e-08 -0.09972305874601885 +2.166 0.7066179113602077 0.7066164738674316 6.127950281410721e-08 -0.099723142759155 +2.1660999999999997 0.7066180610321906 0.7066166213424634 5.9510992578282185e-08 -0.09972322674684014 +2.1662000000000003 0.7066182106398606 0.7066167687917277 5.7719376958531576e-08 -0.09972331070908202 +2.1663 0.7066183601829885 0.706616916215481 5.590507578048798e-08 -0.09972339464588827 +2.1664 0.7066185096613498 0.706617063613975 5.4068513971605725e-08 -0.09972347855726658 +2.1665 0.7066186590747242 0.7066172109874571 5.22101214657511e-08 -0.09972356244322467 +2.1666 0.7066188084228966 0.7066173583361702 5.033033309564949e-08 -0.09972364630377022 +2.1667 0.7066189577056563 0.7066175056603519 4.842958849400614e-08 -0.0997237301389109 +2.1668000000000003 0.7066191069227972 0.706617652960235 4.650833199115745e-08 -0.09972381394865432 +2.1669 0.7066192560741185 0.7066178002360483 4.45670125109876e-08 -0.09972389773300826 +2.167 0.7066194051594239 0.7066179474880148 4.260608346337569e-08 -0.09972398149198033 +2.1671 0.7066195541785223 0.7066180947163532 4.0626002641847014e-08 -0.09972406522557822 +2.1672000000000002 0.7066197031312271 0.7066182419212768 3.8627232112550813e-08 -0.0997241489338096 +2.1673 0.7066198520173574 0.7066183891029938 3.661023812578934e-08 -0.09972423261668206 +2.1674 0.7066200008367365 0.7066185362617082 3.4575490961627486e-08 -0.09972431627420333 +2.1675 0.7066201495891935 0.706618683397618 3.252346487785107e-08 -0.09972439990638106 +2.1675999999999997 0.7066202982745624 0.7066188305109163 3.045463795731118e-08 -0.09972448351322291 +2.1677000000000004 0.7066204468926822 0.7066189776017913 2.8369492009044928e-08 -0.09972456709473652 +2.1678 0.7066205954433975 0.7066191246704252 2.626851246419204e-08 -0.0997246506509295 +2.1679 0.7066207439265578 0.7066192717169961 2.4152188254564222e-08 -0.0997247341818096 +2.168 0.7066208923420181 0.706619418741676 2.2021011694683956e-08 -0.09972481768738439 +2.1681 0.7066210406896386 0.7066195657446317 1.9875478382905265e-08 -0.09972490116766156 +2.1682 0.7066211889692849 0.706619712726025 1.771608707130945e-08 -0.09972498462264873 +2.1683000000000003 0.7066213371808281 0.7066198596860114 1.5543339562489045e-08 -0.09972506805235354 +2.1684 0.7066214853241443 0.706620006624742 1.335774057684147e-08 -0.09972515145678362 +2.1685 0.7066216333991157 0.706620153542362 1.115979764588354e-08 -0.0997252348359466 +2.1686 0.7066217814056293 0.7066203004390109 8.950020999494435e-09 -0.09972531818985014 +2.1687000000000003 0.706621929343578 0.7066204473148234 6.72892343581144e-09 -0.09972540151850189 +2.1688 0.7066220772128602 0.7066205941699277 4.497020203268753e-09 -0.0997254848219094 +2.1689000000000003 0.70662222501338 0.7066207410044472 2.2548288973814334e-09 -0.09972556810008038 +2.169 0.7066223727450467 0.7066208878184994 2.869316763354224e-12 -0.09972565135302242 +2.1691 0.7066225204077756 0.7066210346121962 -2.2583366366193958e-09 -0.09972573458074313 +2.1692000000000005 0.7066226680014873 0.7066211813856436 -4.5282650927569446e-09 -0.09972581778325017 +2.1693000000000002 0.7066228155261082 0.7066213281389426 -6.806390326352663e-09 -0.09972590096055112 +2.1694 0.7066229629815701 0.7066214748721882 -9.092184882590615e-09 -0.0997259841126536 +2.1695 0.706623110367811 0.7066216215854692 -1.1385119698566204e-08 -0.09972606723956519 +2.1696 0.7066232576847742 0.7066217682788696 -1.368466422298209e-08 -0.09972615034129355 +2.1697 0.7066234049324089 0.7066219149524671 -1.599028654538509e-08 -0.0997262334178463 +2.1698000000000004 0.7066235521106696 0.706622061606334 -1.830145351195897e-08 -0.09972631646923097 +2.1699 0.7066236992195174 0.7066222082405365 -2.061763084912349e-08 -0.09972639949545525 +2.17 0.7066238462589183 0.7066223548551351 -2.2938283293638673e-08 -0.09972648249652669 +2.1700999999999997 0.7066239932288443 0.7066225014501852 -2.5262874710132305e-08 -0.0997265654724529 +2.1702000000000004 0.7066241401292734 0.7066226480257356 -2.7590868216000042e-08 -0.09972664842324153 +2.1703 0.7066242869601893 0.7066227945818295 -2.9921726309124416e-08 -0.0997267313489001 +2.1704 0.706624433721581 0.7066229411185048 -3.22549109877876e-08 -0.09972681424943625 +2.1705 0.7066245804134441 0.706623087635793 -3.458988387448729e-08 -0.09972689712485755 +2.1706 0.706624727035779 0.7066232341337201 -3.692610634408941e-08 -0.0997269799751716 +2.1707 0.7066248735885929 0.7066233806123061 -3.9263039642981924e-08 -0.09972706280038594 +2.1708000000000003 0.7066250200718979 0.706623527071566 -4.160014501852858e-08 -0.09972714560050822 +2.1709 0.7066251664857124 0.7066236735115078 -4.3936883839035875e-08 -0.09972722837554596 +2.171 0.7066253128300605 0.7066238199321344 -4.6272717720008405e-08 -0.09972731112550676 +2.1711 0.7066254591049719 0.706623966333443 -4.8607108647314226e-08 -0.0997273938503982 +2.1712000000000002 0.7066256053104821 0.7066241127154251 -5.093951910316915e-08 -0.09972747655022786 +2.1713 0.7066257514466328 0.706624259078066 -5.326941218426057e-08 -0.09972755922500331 +2.1714 0.7066258975134706 0.7066244054213452 -5.5596251732339605e-08 -0.0997276418747321 +2.1715 0.706626043511049 0.706624551745237 -5.7919502451314955e-08 -0.09972772449942184 +2.1715999999999998 0.7066261894394259 0.7066246980497097 -6.023863003724872e-08 -0.09972780709908007 +2.1717000000000004 0.7066263352986659 0.7066248443347258 -6.25531012925229e-08 -0.09972788967371436 +2.1718 0.7066264810888387 0.7066249906002421 -6.486238425702784e-08 -0.09972797222333224 +2.1719 0.7066266268100202 0.7066251368462095 -6.716594832438874e-08 -0.0997280547479413 +2.172 0.7066267724622919 0.7066252830725738 -6.946326436534783e-08 -0.09972813724754909 +2.1721 0.7066269180457403 0.7066254292792746 -7.175380485483288e-08 -0.09972821972216316 +2.1722 0.7066270635604586 0.7066255754662459 -7.403704397864266e-08 -0.09972830217179104 +2.1723000000000003 0.7066272090065446 0.7066257216334164 -7.631245777005649e-08 -0.09972838459644032 +2.1724 0.7066273543841024 0.706625867780709 -7.857952422519326e-08 -0.09972846699611852 +2.1725 0.7066274996932416 0.7066260139080409 -8.083772341533485e-08 -0.0997285493708332 +2.1726 0.7066276449340768 0.7066261600153239 -8.308653761269352e-08 -0.09972863172059188 +2.1727000000000003 0.7066277901067288 0.7066263061024642 -8.532545141531206e-08 -0.09972871404540212 +2.1728 0.7066279352113234 0.7066264521693627 -8.755395184724402e-08 -0.09972879634527144 +2.1729000000000003 0.7066280802479921 0.7066265982159144 -8.977152849386216e-08 -0.0997288786202074 +2.173 0.7066282252168719 0.7066267442420093 -9.197767361114606e-08 -0.09972896087021753 +2.1731 0.7066283701181049 0.7066268902475318 -9.417188223757172e-08 -0.09972904309530933 +2.1732000000000005 0.7066285149518392 0.7066270362323606 -9.635365231901172e-08 -0.09972912529549038 +2.1733000000000002 0.7066286597182276 0.7066271821963693 -9.852248481889009e-08 -0.09972920747076815 +2.1734 0.7066288044174288 0.7066273281394266 -1.0067788383354148e-07 -0.09972928962115021 +2.1735 0.7066289490496062 0.7066274740613951 -1.0281935669369247e-07 -0.09972937174664409 +2.1736 0.7066290936149284 0.7066276199621329 -1.049464141032394e-07 -0.09972945384725725 +2.1737 0.70662923811357 0.7066277658414923 -1.0705857022251519e-07 -0.09972953592299721 +2.1738000000000004 0.7066293825457102 0.7066279116993206 -1.0915534280186295e-07 -0.09972961797387155 +2.1739 0.706629526911533 0.7066280575354602 -1.1123625327964792e-07 -0.09972969999988772 +2.174 0.7066296712112283 0.7066282033497483 -1.1330082688373877e-07 -0.0997297820010533 +2.1740999999999997 0.7066298154449906 0.7066283491420168 -1.1534859276421394e-07 -0.09972986397737571 +2.1742000000000004 0.7066299596130194 0.7066284949120931 -1.1737908407923048e-07 -0.09972994592886256 +2.1743 0.7066301037155192 0.7066286406597988 -1.1939183810691367e-07 -0.09973002785552125 +2.1744 0.7066302477526991 0.7066287863849514 -1.2138639635984882e-07 -0.09973010975735935 +2.1745 0.7066303917247736 0.7066289320873633 -1.2336230467355214e-07 -0.09973019163438433 +2.1746 0.7066305356319619 0.7066290777668418 -1.2531911331922774e-07 -0.0997302734866037 +2.1747 0.7066306794744877 0.7066292234231898 -1.2725637711305526e-07 -0.09973035531402491 +2.1748000000000003 0.7066308232525795 0.7066293690562051 -1.2917365549598714e-07 -0.09973043711665554 +2.1749 0.7066309669664708 0.7066295146656811 -1.3107051265864866e-07 -0.09973051889450302 +2.175 0.7066311106163993 0.7066296602514066 -1.329465176280742e-07 -0.09973060064757483 +2.1751 0.7066312542026073 0.7066298058131658 -1.348012443544433e-07 -0.09973068237587851 +2.1752000000000002 0.706631397725342 0.7066299513507377 -1.3663427183424615e-07 -0.09973076407942148 +2.1753 0.7066315411848543 0.7066300968638981 -1.3844518418661134e-07 -0.09973084575821121 +2.1754000000000002 0.7066316845814005 0.7066302423524176 -1.402335707504504e-07 -0.0997309274122553 +2.1755 0.7066318279152406 0.7066303878160625 -1.4199902618333704e-07 -0.09973100904156113 +2.1755999999999998 0.7066319711866385 0.7066305332545947 -1.4374115054824332e-07 -0.09973109064613613 +2.1757000000000004 0.7066321143958635 0.7066306786677725 -1.4545954940027583e-07 -0.09973117222598789 +2.1758 0.706632257543188 0.7066308240553494 -1.4715383388208547e-07 -0.09973125378112382 +2.1759 0.706632400628889 0.706630969417075 -1.488236208227467e-07 -0.0997313353115514 +2.176 0.7066325436532473 0.7066311147526947 -1.504685327880645e-07 -0.09973141681727804 +2.1761 0.706632686616548 0.7066312600619502 -1.5208819821761754e-07 -0.09973149829831127 +2.1762 0.7066328295190796 0.7066314053445792 -1.5368225146292214e-07 -0.09973157975465853 +2.1763000000000003 0.706632972361135 0.7066315506003158 -1.5525033288978085e-07 -0.09973166118632731 +2.1764 0.7066331151430105 0.7066316958288894 -1.5679208896501873e-07 -0.09973174259332503 +2.1765 0.7066332578650061 0.7066318410300266 -1.5830717232240277e-07 -0.0997318239756591 +2.1766 0.7066334005274258 0.70663198620345 -1.5979524184590865e-07 -0.09973190533333706 +2.1767000000000003 0.706633543130577 0.7066321313488788 -1.6125596276513054e-07 -0.09973198666636635 +2.1768 0.7066336856747706 0.706632276466028 -1.6268900668303665e-07 -0.09973206797475434 +2.1769000000000003 0.7066338281603208 0.70663242155461 -1.640940517060735e-07 -0.09973214925850854 +2.177 0.7066339705875455 0.7066325666143336 -1.6547078247712566e-07 -0.09973223051763641 +2.1771 0.7066341129567655 0.706632711644904 -1.6681889026051722e-07 -0.09973231175214534 +2.1772000000000005 0.706634255268305 0.7066328566460237 -1.6813807300793127e-07 -0.09973239296204282 +2.1773000000000002 0.7066343975224916 0.7066330016173912 -1.6942803543473772e-07 -0.09973247414733621 +2.1774 0.7066345397196554 0.7066331465587026 -1.706884890685656e-07 -0.09973255530803304 +2.1775 0.7066346818601299 0.7066332914696509 -1.7191915233603916e-07 -0.09973263644414064 +2.1776 0.706634823944252 0.7066334363499257 -1.7311975060961549e-07 -0.09973271755566653 +2.1777 0.7066349659723605 0.7066335811992144 -1.742900162700345e-07 -0.09973279864261807 +2.1778000000000004 0.7066351079447977 0.7066337260172012 -1.7542968877570786e-07 -0.09973287970500273 +2.1779 0.706635249861908 0.7066338708035675 -1.7653851470608717e-07 -0.0997329607428279 +2.178 0.7066353917240391 0.7066340155579924 -1.7761624783452223e-07 -0.09973304175610102 +2.1780999999999997 0.7066355335315407 0.7066341602801524 -1.7866264916469032e-07 -0.09973312274482951 +2.1782000000000004 0.7066356752847653 0.7066343049697211 -1.796774869930462e-07 -0.09973320370902079 +2.1783 0.7066358169840679 0.7066344496263701 -1.8066053696433326e-07 -0.09973328464868225 +2.1784 0.7066359586298051 0.7066345942497686 -1.8161158212362527e-07 -0.09973336556382131 +2.1785 0.7066361002223367 0.7066347388395837 -1.82530412937143e-07 -0.09973344645444543 +2.1786 0.706636241762024 0.7066348833954801 -1.834168273824599e-07 -0.09973352732056195 +2.1787 0.7066363832492306 0.7066350279171201 -1.8427063094156315e-07 -0.0997336081621783 +2.1788000000000003 0.706636524684322 0.7066351724041648 -1.8509163669105932e-07 -0.0997336889793019 +2.1789 0.7066366660676657 0.7066353168562729 -1.8587966532992994e-07 -0.09973376977194014 +2.179 0.706636807399631 0.7066354612731012 -1.866345451725926e-07 -0.09973385054010037 +2.1791 0.7066369486805889 0.706635605654305 -1.8735611227033155e-07 -0.09973393128379004 +2.1792000000000002 0.7066370899109121 0.7066357499995379 -1.8804421035578667e-07 -0.09973401200301657 +2.1793 0.7066372310909749 0.7066358943084516 -1.886986909678534e-07 -0.09973409269778728 +2.1794000000000002 0.706637372221153 0.7066360385806971 -1.89319413413519e-07 -0.09973417336810964 +2.1795 0.7066375133018237 0.7066361828159228 -1.8990624481990404e-07 -0.09973425401399098 +2.1795999999999998 0.706637654333365 0.7066363270137765 -1.904590601620182e-07 -0.09973433463543864 +2.1797000000000004 0.7066377953161571 0.7066364711739047 -1.9097774231133235e-07 -0.09973441523246009 +2.1798 0.706637936250581 0.7066366152959529 -1.9146218201149257e-07 -0.0997344958050627 +2.1799 0.7066380771370184 0.706636759379565 -1.9191227795464783e-07 -0.09973457635325383 +2.18 0.7066382179758524 0.7066369034243845 -1.9232793677104176e-07 -0.09973465687704086 +2.1801 0.7066383587674667 0.7066370474300534 -1.9270907304289042e-07 -0.0997347373764312 +2.1802 0.706638499512246 0.7066371913962132 -1.9305560936336286e-07 -0.09973481785143212 +2.1803000000000003 0.7066386402105758 0.7066373353225046 -1.9336747629494777e-07 -0.09973489830205108 +2.1804 0.706638780862842 0.7066374792085679 -1.93644612435373e-07 -0.09973497872829541 +2.1805 0.7066389214694313 0.7066376230540425 -1.938869643690333e-07 -0.09973505913017253 +2.1806 0.7066390620307307 0.7066377668585676 -1.9409448675025698e-07 -0.09973513950768972 +2.1807000000000003 0.7066392025471275 0.7066379106217817 -1.942671422512643e-07 -0.09973521986085439 +2.1808 0.7066393430190097 0.7066380543433228 -1.9440490158645352e-07 -0.09973530018967386 +2.1809000000000003 0.7066394834467651 0.7066381980228296 -1.9450774355056488e-07 -0.09973538049415553 +2.181 0.7066396238307819 0.7066383416599397 -1.9457565495276108e-07 -0.09973546077430673 +2.1811 0.7066397641714479 0.7066384852542913 -1.9460863068948564e-07 -0.09973554103013482 +2.1812000000000005 0.7066399044691517 0.7066386288055224 -1.9460667371323792e-07 -0.0997356212616472 +2.1813000000000002 0.7066400447242809 0.706638772313271 -1.9456979497706195e-07 -0.09973570146885116 +2.1814 0.7066401849372231 0.7066389157771753 -1.9449801353516039e-07 -0.09973578165175402 +2.1815 0.7066403251083659 0.7066390591968743 -1.9439135644575e-07 -0.0997358618103632 +2.1816 0.7066404652380964 0.7066392025720065 -1.9424985880575618e-07 -0.09973594194468599 +2.1817 0.7066406053268008 0.7066393459022118 -1.9407356372305729e-07 -0.0997360220547297 +2.1818 0.7066407453748653 0.7066394891871304 -1.9386252233383194e-07 -0.09973610214050177 +2.1819 0.706640885382675 0.7066396324264024 -1.936167937643951e-07 -0.0997361822020094 +2.182 0.7066410253506146 0.7066397756196696 -1.9333644508609527e-07 -0.09973626223926 +2.1820999999999997 0.7066411652790681 0.7066399187665744 -1.9302155134653942e-07 -0.09973634225226094 +2.1822000000000004 0.7066413051684178 0.7066400618667593 -1.9267219554877646e-07 -0.09973642224101945 +2.1823 0.7066414450190458 0.706640204919869 -1.9228846858190818e-07 -0.09973650220554287 +2.1824 0.706641584831333 0.7066403479255484 -1.9187046925925322e-07 -0.09973658214583858 +2.1825 0.7066417246056589 0.7066404908834443 -1.9141830424895812e-07 -0.09973666206191392 +2.1826 0.706641864342402 0.7066406337932037 -1.9093208805318063e-07 -0.09973674195377613 +2.1827 0.7066420040419389 0.7066407766544758 -1.9041194300115083e-07 -0.09973682182143255 +2.1828000000000003 0.7066421437046458 0.706640919466911 -1.8985799917631274e-07 -0.09973690166489056 +2.1829 0.7066422833308966 0.7066410622301609 -1.8927039445795768e-07 -0.09973698148415741 +2.183 0.7066424229210637 0.7066412049438786 -1.8864927441020196e-07 -0.09973706127924038 +2.1831 0.706642562475518 0.7066413476077196 -1.879947922819869e-07 -0.09973714105014683 +2.1832000000000003 0.7066427019946288 0.7066414902213407 -1.87307108961976e-07 -0.09973722079688407 +2.1833 0.7066428414787633 0.7066416327844002 -1.8658639295426882e-07 -0.0997373005194594 +2.1834000000000002 0.706642980928287 0.7066417752965586 -1.858328203194204e-07 -0.0997373802178801 +2.1835 0.7066431203435634 0.7066419177574785 -1.8504657462239948e-07 -0.09973745989215348 +2.1835999999999998 0.7066432597249535 0.7066420601668243 -1.842278469221803e-07 -0.09973753954228681 +2.1837000000000004 0.7066433990728167 0.7066422025242627 -1.8337683569541463e-07 -0.09973761916828744 +2.1838 0.7066435383875098 0.7066423448294625 -1.824937468121457e-07 -0.09973769877016261 +2.1839 0.7066436776693878 0.7066424870820951 -1.8157879345948036e-07 -0.09973777834791966 +2.184 0.706643816918803 0.706642629281834 -1.8063219609995573e-07 -0.09973785790156585 +2.1841 0.7066439561361048 0.706642771428355 -1.7965418244725306e-07 -0.09973793743110845 +2.1842 0.706644095321641 0.7066429135213365 -1.7864498735170597e-07 -0.09973801693655476 +2.1843000000000004 0.7066442344757558 0.7066430555604599 -1.7760485281417826e-07 -0.09973809641791205 +2.1844 0.7066443735987916 0.706643197545409 -1.765340278611638e-07 -0.09973817587518764 +2.1845 0.7066445126910874 0.7066433394758702 -1.754327685447865e-07 -0.09973825530838876 +2.1846 0.7066446517529796 0.7066434813515332 -1.7430133783177815e-07 -0.09973833471752269 +2.1847000000000003 0.7066447907848017 0.7066436231720903 -1.7314000557225318e-07 -0.09973841410259675 +2.1848 0.706644929786884 0.7066437649372362 -1.719490484389935e-07 -0.09973849346361813 +2.1849000000000003 0.7066450687595544 0.7066439066466699 -1.7072874981816089e-07 -0.09973857280059419 +2.185 0.7066452077031367 0.7066440483000928 -1.6947939981103166e-07 -0.09973865211353214 +2.1851 0.7066453466179523 0.7066441898972092 -1.682012950986883e-07 -0.09973873140243925 +2.1852000000000005 0.7066454855043189 0.7066443314377273 -1.6689473889691664e-07 -0.09973881066732279 +2.1853000000000002 0.706645624362551 0.706644472921358 -1.65560040911103e-07 -0.09973888990819 +2.1854 0.7066457631929599 0.7066446143478164 -1.6419751721480358e-07 -0.0997389691250482 +2.1855 0.7066459019958531 0.7066447557168203 -1.6280749022198893e-07 -0.09973904831790459 +2.1856 0.7066460407715345 0.7066448970280913 -1.613902885638785e-07 -0.09973912748676643 +2.1857 0.7066461795203047 0.7066450382813548 -1.5994624706291982e-07 -0.09973920663164099 +2.1858 0.7066463182424604 0.70664517947634 -1.58475706604419e-07 -0.09973928575253549 +2.1859 0.7066464569382946 0.7066453206127787 -1.56979014084499e-07 -0.09973936484945717 +2.186 0.706646595608097 0.706645461690408 -1.554565223181592e-07 -0.0997394439224133 +2.1860999999999997 0.7066467342521523 0.706645602708968 -1.539085899664172e-07 -0.09973952297141112 +2.1862000000000004 0.7066468728707422 0.706645743668203 -1.523355814495725e-07 -0.09973960199645784 +2.1863 0.7066470114641445 0.7066458845678611 -1.5073786683444945e-07 -0.09973968099756077 +2.1864 0.7066471500326323 0.7066460254076945 -1.4911582180143768e-07 -0.0997397599747271 +2.1865 0.7066472885764747 0.7066461661874599 -1.474698275039793e-07 -0.09973983892796405 +2.1866 0.7066474270959374 0.7066463069069171 -1.4580027051132316e-07 -0.09973991785727886 +2.1867 0.7066475655912812 0.7066464475658316 -1.441075426922983e-07 -0.0997399967626788 +2.1868000000000003 0.7066477040627623 0.7066465881639717 -1.4239204115980286e-07 -0.09974007564417106 +2.1869 0.7066478425106334 0.706646728701111 -1.4065416813376086e-07 -0.09974015450176282 +2.187 0.7066479809351424 0.706646869177027 -1.388943308786722e-07 -0.09974023333546139 +2.1871 0.7066481193365328 0.7066470095915021 -1.371129416029987e-07 -0.09974031214527397 +2.1872000000000003 0.7066482577150439 0.7066471499443223 -1.3531041734293758e-07 -0.09974039093120773 +2.1873 0.7066483960709096 0.7066472902352791 -1.334871798999715e-07 -0.09974046969326993 +2.1874000000000002 0.7066485344043602 0.7066474304641681 -1.3164365570209058e-07 -0.09974054843146775 +2.1875 0.7066486727156207 0.7066475706307898 -1.2978027574481188e-07 -0.09974062714580845 +2.1875999999999998 0.7066488110049118 0.7066477107349489 -1.2789747544719732e-07 -0.0997407058362992 +2.1877000000000004 0.7066489492724495 0.7066478507764553 -1.2599569459287308e-07 -0.09974078450294725 +2.1878 0.7066490875184446 0.7066479907551235 -1.2407537719472117e-07 -0.09974086314575975 +2.1879 0.7066492257431034 0.7066481306707728 -1.22136971409878e-07 -0.09974094176474395 +2.188 0.706649363946627 0.7066482705232273 -1.2018092943044678e-07 -0.09974102035990699 +2.1881 0.7066495021292121 0.7066484103123161 -1.1820770736727104e-07 -0.09974109893125611 +2.1882 0.7066496402910505 0.7066485500378732 -1.1621776517013738e-07 -0.09974117747879856 +2.1883000000000004 0.7066497784323282 0.7066486896997373 -1.142115664855281e-07 -0.09974125600254141 +2.1884 0.706649916553227 0.7066488292977529 -1.1218957858202816e-07 -0.09974133450249194 +2.1885 0.706650054653923 0.7066489688317686 -1.101522722098125e-07 -0.09974141297865731 +2.1886 0.706650192734588 0.706649108301639 -1.0810012152431825e-07 -0.09974149143104472 +2.1887000000000003 0.706650330795388 0.706649247707223 -1.0603360395006894e-07 -0.09974156985966137 +2.1888 0.7066504688364839 0.7066493870483852 -1.0395320008179526e-07 -0.0997416482645144 +2.1889000000000003 0.7066506068580316 0.7066495263249953 -1.0185939356473911e-07 -0.09974172664561105 +2.189 0.7066507448601818 0.7066496655369281 -9.975267099664176e-08 -0.09974180500295848 +2.1891 0.7066508828430796 0.7066498046840636 -9.763352179937429e-08 -0.09974188333656382 +2.1892000000000005 0.7066510208068653 0.7066499437662872 -9.550243810965003e-08 -0.0997419616464343 +2.1893000000000002 0.7066511587516736 0.7066500827834898 -9.335991467320642e-08 -0.0997420399325771 +2.1894 0.7066512966776335 0.7066502217355674 -9.120644871643546e-08 -0.09974211819499933 +2.1895 0.7066514345848696 0.7066503606224213 -8.904253984316768e-08 -0.0997421964337082 +2.1896 0.7066515724734999 0.7066504994439584 -8.686868990456786e-08 -0.09974227464871088 +2.1897 0.7066517103436379 0.7066506382000908 -8.46854029011232e-08 -0.09974235284001454 +2.1898 0.7066518481953914 0.7066507768907363 -8.249318485340634e-08 -0.09974243100762632 +2.1899 0.7066519860288623 0.7066509155158178 -8.029254368931843e-08 -0.09974250915155336 +2.19 0.706652123844148 0.7066510540752641 -7.808398912092368e-08 -0.0997425872718029 +2.1900999999999997 0.7066522616413394 0.7066511925690091 -7.586803253516183e-08 -0.09974266536838201 +2.1902000000000004 0.7066523994205225 0.7066513309969924 -7.364518686677965e-08 -0.0997427434412979 +2.1903 0.7066525371817771 0.7066514693591589 -7.141596648860965e-08 -0.09974282149055763 +2.1904 0.7066526749251787 0.7066516076554595 -6.918088708146586e-08 -0.09974289951616849 +2.1905 0.7066528126507958 0.7066517458858506 -6.69404655252899e-08 -0.09974297751813757 +2.1906 0.7066529503586925 0.7066518840502931 -6.469521977772036e-08 -0.09974305549647197 +2.1907 0.7066530880489266 0.7066520221487551 -6.244566874528956e-08 -0.0997431334511789 +2.1908000000000003 0.7066532257215503 0.7066521601812091 -6.01923321763044e-08 -0.09974321138226541 +2.1909 0.7066533633766108 0.7066522981476338 -5.7935730533127325e-08 -0.09974328928973873 +2.191 0.7066535010141488 0.7066524360480128 -5.5676384874215126e-08 -0.09974336717360589 +2.1911 0.7066536386342006 0.7066525738823359 -5.341481673051991e-08 -0.09974344503387415 +2.1912000000000003 0.7066537762367961 0.7066527116505986 -5.115154799381627e-08 -0.09974352287055058 +2.1913 0.7066539138219596 0.7066528493528016 -4.8887100787139114e-08 -0.09974360068364228 +2.1914000000000002 0.7066540513897102 0.7066529869889513 -4.662199734649722e-08 -0.09974367847315645 +2.1915 0.7066541889400604 0.7066531245590599 -4.4356759904104655e-08 -0.09974375623910019 +2.1915999999999998 0.7066543264730183 0.7066532620631449 -4.2091910566367384e-08 -0.09974383398148057 +2.1917000000000004 0.7066544639885858 0.7066533995012294 -3.982797119108381e-08 -0.09974391170030472 +2.1918 0.7066546014867593 0.7066535368733426 -3.7565463270540674e-08 -0.09974398939557984 +2.1919 0.7066547389675296 0.7066536741795189 -3.5304907807995334e-08 -0.09974406706731297 +2.192 0.706654876430882 0.7066538114197981 -3.3046825202113356e-08 -0.0997441447155113 +2.1921 0.706655013876796 0.706653948594226 -3.079173512454854e-08 -0.09974422234018188 +2.1922 0.7066551513052457 0.7066540857028534 -2.8540156398349642e-08 -0.0997442999413318 +2.1923000000000004 0.7066552887161996 0.7066542227457373 -2.629260688574546e-08 -0.09974437751896822 +2.1924 0.7066554261096204 0.7066543597229402 -2.40496033582574e-08 -0.09974445507309826 +2.1925 0.7066555634854658 0.7066544966345296 -2.1811661389363468e-08 -0.099744532603729 +2.1926 0.7066557008436875 0.7066546334805786 -1.957929522764662e-08 -0.0997446101108675 +2.1927000000000003 0.7066558381842319 0.7066547702611663 -1.735301768468825e-08 -0.09974468759452092 +2.1928 0.70665597550704 0.706654906976377 -1.51333400112523e-08 -0.09974476505469634 +2.1929000000000003 0.7066561128120469 0.7066550436263003 -1.2920771782793522e-08 -0.09974484249140084 +2.193 0.7066562500991826 0.7066551802110315 -1.07158207853994e-08 -0.09974491990464152 +2.1931 0.7066563873683722 0.7066553167306712 -8.518992895660549e-09 -0.09974499729442551 +2.1932000000000005 0.7066565246195342 0.7066554531853253 -6.330791967046334e-09 -0.09974507466075984 +2.1933000000000002 0.7066566618525826 0.7066555895751052 -4.151719709341584e-09 -0.09974515200365165 +2.1934 0.7066567990674256 0.7066557259001279 -1.98227557892533e-09 -0.09974522932310802 +2.1935 0.7066569362639663 0.7066558621605152 1.770433339862154e-10 -0.09974530661913598 +2.1936 0.7066570734421023 0.7066559983563947 2.3257424293723905e-09 -0.09974538389174263 +2.1937 0.7066572106017261 0.7066561344878989 4.463329697154683e-09 -0.09974546114093508 +2.1938 0.706657347742725 0.7066562705551656 6.589315835157927e-09 -0.09974553836672036 +2.1939 0.7066574848649808 0.7066564065583383 8.703214369673584e-09 -0.09974561556910559 +2.194 0.7066576219683705 0.7066565424975649 1.0804541756073704e-08 -0.09974569274809782 +2.1940999999999997 0.7066577590527652 0.7066566783729991 1.28928174950374e-08 -0.0997457699037041 +2.1942000000000004 0.7066578961180321 0.7066568141847995 1.496756423316481e-08 -0.09974584703593158 +2.1943 0.7066580331640322 0.7066569499331296 1.702830788267301e-08 -0.09974592414478727 +2.1944 0.7066581701906218 0.7066570856181578 1.9074577728948883e-08 -0.09974600123027816 +2.1945 0.7066583071976522 0.7066572212400584 2.1105906529428342e-08 -0.0997460782924114 +2.1946 0.7066584441849699 0.7066573567990099 2.3121830630690177e-08 -0.09974615533119408 +2.1947 0.7066585811524164 0.7066574922951958 2.512189005952903e-08 -0.09974623234663321 +2.1948000000000003 0.7066587180998277 0.7066576277288048 2.7105628653059655e-08 -0.09974630933873581 +2.1949 0.7066588550270362 0.7066577631000298 2.9072594141116292e-08 -0.09974638630750898 +2.195 0.7066589919338686 0.7066578984090692 3.1022338248601344e-08 -0.09974646325295983 +2.1951 0.7066591288201465 0.7066580336561259 3.295441680997713e-08 -0.09974654017509527 +2.1952000000000003 0.7066592656856878 0.7066581688414073 3.4868389864675664e-08 -0.09974661707392245 +2.1953 0.706659402530305 0.706658303965126 3.676382175944737e-08 -0.09974669394944836 +2.1954000000000002 0.706659539353806 0.7066584390274985 3.864028124550556e-08 -0.09974677080168005 +2.1955 0.7066596761559946 0.7066585740287467 4.049734156873208e-08 -0.09974684763062461 +2.1955999999999998 0.7066598129366696 0.7066587089690961 4.233458058416906e-08 -0.09974692443628903 +2.1957000000000004 0.7066599496956254 0.7066588438487775 4.415158083408144e-08 -0.09974700121868035 +2.1958 0.7066600864326522 0.7066589786680259 4.594792966071404e-08 -0.09974707797780559 +2.1959 0.7066602231475356 0.7066591134270801 4.7723219277415185e-08 -0.09974715471367182 +2.196 0.7066603598400572 0.706659248126184 4.947704689006738e-08 -0.09974723142628605 +2.1961 0.7066604965099939 0.706659382765585 5.1209014752598425e-08 -0.09974730811565531 +2.1962 0.7066606331571186 0.7066595173455357 5.291873029882044e-08 -0.09974738478178669 +2.1963000000000004 0.7066607697812001 0.7066596518662919 5.460580618579791e-08 -0.0997474614246871 +2.1964 0.7066609063820031 0.7066597863281139 5.626986042915616e-08 -0.09974753804436363 +2.1965 0.7066610429592879 0.7066599207312658 5.791051644991885e-08 -0.09974761464082327 +2.1966 0.7066611795128115 0.706660055076016 5.95274031785914e-08 -0.09974769121407304 +2.1967000000000003 0.7066613160423265 0.7066601893626367 6.112015512454994e-08 -0.09974776776411998 +2.1968 0.7066614525475816 0.7066603235914042 6.268841249747192e-08 -0.09974784429097112 +2.1969000000000003 0.706661589028322 0.7066604577625977 6.423182124029592e-08 -0.09974792079463342 +2.197 0.7066617254842888 0.706660591876501 6.575003313157024e-08 -0.0997479972751139 +2.1971 0.7066618619152201 0.7066607259334013 6.724270585831138e-08 -0.09974807373241956 +2.1972000000000005 0.7066619983208495 0.7066608599335893 6.870950311141377e-08 -0.09974815016655744 +2.1973000000000003 0.7066621347009078 0.7066609938773596 7.015009463248734e-08 -0.09974822657753452 +2.1974 0.7066622710551216 0.7066611277650099 7.156415630753254e-08 -0.0997483029653578 +2.1975 0.7066624073832151 0.706661261596841 7.295137023459464e-08 -0.09974837933003429 +2.1976 0.7066625436849083 0.7066613953731576 7.431142480009145e-08 -0.09974845567157098 +2.1977 0.7066626799599183 0.7066615290942677 7.564401473432458e-08 -0.09974853198997485 +2.1978 0.7066628162079587 0.7066616627604818 7.69488411947461e-08 -0.0997486082852529 +2.1979 0.7066629524287403 0.7066617963721145 7.822561183014332e-08 -0.09974868455741209 +2.198 0.7066630886219709 0.7066619299294826 7.94740408326805e-08 -0.09974876080645949 +2.1980999999999997 0.706663224787355 0.7066620634329064 8.069384902290033e-08 -0.099748837032402 +2.1982000000000004 0.7066633609245943 0.7066621968827089 8.188476389482668e-08 -0.09974891323524665 +2.1983 0.7066634970333875 0.7066623302792159 8.304651969749666e-08 -0.09974898941500038 +2.1984 0.7066636331134311 0.7066624636227561 8.417885745924669e-08 -0.09974906557167025 +2.1985 0.7066637691644182 0.7066625969136611 8.528152508832654e-08 -0.0997491417052632 +2.1986 0.7066639051860396 0.7066627301522643 8.635427739545065e-08 -0.09974921781578616 +2.1987 0.7066640411779835 0.7066628633389027 8.73968761597177e-08 -0.0997492939032461 +2.1988000000000003 0.706664177139936 0.7066629964739151 8.840909018065224e-08 -0.09974936996765012 +2.1989 0.7066643130715801 0.7066631295576428 8.939069533545063e-08 -0.09974944600900505 +2.199 0.7066644489725967 0.7066632625904294 9.034147462061437e-08 -0.09974952202731792 +2.1991 0.7066645848426647 0.7066633955726211 9.12612182039918e-08 -0.09974959802259564 +2.1992000000000003 0.706664720681461 0.7066635285045655 9.214972346294203e-08 -0.09974967399484524 +2.1993 0.70666485648866 0.7066636613866131 9.300679504331555e-08 -0.09974974994407365 +2.1994000000000002 0.7066649922639339 0.7066637942191158 9.383224490108755e-08 -0.09974982587028781 +2.1995 0.7066651280069534 0.7066639270024281 9.462589230929686e-08 -0.0997499017734947 +2.1995999999999998 0.7066652637173878 0.7066640597369053 9.538756396212933e-08 -0.09974997765370128 +2.1997000000000004 0.7066653993949031 0.7066641924229056 9.611709394022339e-08 -0.09975005351091448 +2.1998 0.7066655350391653 0.7066643250607885 9.681432381128396e-08 -0.0997501293451413 +2.1999 0.7066656706498378 0.7066644576509142 9.747910261967418e-08 -0.0997502051563886 +2.2 0.7066658062265826 0.7066645901936459 9.811128693845705e-08 -0.0997502809446634 +2.2001 0.7066659417690606 0.7066647226893474 9.87107408867427e-08 -0.09975035670997262 +2.2002 0.7066660772769309 0.7066648551383838 9.927733618866896e-08 -0.0997504324523232 +2.2003000000000004 0.7066662127498516 0.7066649875411217 9.981095215952362e-08 -0.09975050817172205 +2.2004 0.7066663481874795 0.7066651198979292 1.0031147576819444e-07 -0.09975058386817616 +2.2005 0.7066664835894705 0.7066652522091748 1.0077880163369968e-07 -0.09975065954169243 +2.2006 0.7066666189554789 0.7066653844752286 1.0121283205641318e-07 -0.09975073519227781 +2.2007000000000003 0.7066667542851586 0.7066655166964614 1.0161347704235046e-07 -0.09975081081993921 +2.2008 0.7066668895781625 0.7066656488732451 1.019806543239854e-07 -0.09975088642468362 +2.2009000000000003 0.7066670248341423 0.7066657810059521 1.023142893810669e-07 -0.0997509620065179 +2.201 0.7066671600527497 0.7066659130949557 1.0261431541633281e-07 -0.099751037565449 +2.2011 0.706667295233635 0.7066660451406297 1.0288067343530716e-07 -0.09975111310148384 +2.2012000000000005 0.7066674303764487 0.7066661771433487 1.0311331218731956e-07 -0.09975118861462934 +2.2013000000000003 0.7066675654808403 0.706666309103487 1.0331218823836363e-07 -0.0997512641048924 +2.2014 0.7066677005464592 0.7066664410214201 1.034772659364025e-07 -0.09975133957227997 +2.2015 0.7066678355729545 0.7066665728975239 1.0360851740096044e-07 -0.09975141501679902 +2.2016 0.706667970559975 0.7066667047321734 1.0370592261679801e-07 -0.09975149043845634 +2.2017 0.7066681055071691 0.7066668365257446 1.0376946931942022e-07 -0.09975156583725889 +2.2018 0.7066682404141857 0.7066669682786133 1.037991530852822e-07 -0.09975164121321355 +2.2019 0.7066683752806736 0.7066670999911555 1.0379497727974751e-07 -0.09975171656632731 +2.202 0.7066685101062816 0.7066672316637466 1.0375695309525201e-07 -0.09975179189660699 +2.2020999999999997 0.7066686448906587 0.7066673632967622 1.0368509948885385e-07 -0.09975186720405954 +2.2022000000000004 0.7066687796334543 0.7066674948905771 1.0357944322039736e-07 -0.09975194248869185 +2.2023 0.7066689143343179 0.7066676264455662 1.0344001885251308e-07 -0.0997520177505108 +2.2024 0.7066690489929 0.7066677579621039 1.0326686867775936e-07 -0.09975209298952331 +2.2025 0.7066691836088513 0.7066678894405638 1.0306004279841963e-07 -0.09975216820573628 +2.2026 0.7066693181818229 0.7066680208813189 1.0281959902588844e-07 -0.09975224339915656 +2.2027 0.7066694527114672 0.7066681522847416 1.025456029327132e-07 -0.0997523185697911 +2.2028000000000003 0.7066695871974369 0.7066682836512033 1.0223812775891905e-07 -0.09975239371764671 +2.2029 0.7066697216393858 0.7066684149810749 1.018972544987451e-07 -0.09975246884273037 +2.203 0.7066698560369686 0.7066685462747258 1.0152307178268316e-07 -0.09975254394504886 +2.2031 0.7066699903898412 0.7066686775325248 1.0111567588788617e-07 -0.09975261902460916 +2.2032000000000003 0.7066701246976601 0.7066688087548394 1.0067517073816812e-07 -0.09975269408141806 +2.2033 0.7066702589600837 0.7066689399420358 1.0020166782073736e-07 -0.0997527691154825 +2.2034000000000002 0.7066703931767714 0.7066690710944792 9.969528624864665e-08 -0.09975284412680933 +2.2035 0.7066705273473839 0.7066692022125329 9.915615263589306e-08 -0.09975291911540543 +2.2036 0.7066706614715832 0.7066693332965592 9.858440112517353e-08 -0.09975299408127766 +2.2037000000000004 0.7066707955490332 0.7066694643469189 9.79801733219654e-08 -0.09975306902443289 +2.2038 0.7066709295793991 0.7066695953639708 9.734361828758753e-08 -0.09975314394487801 +2.2039 0.7066710635623482 0.7066697263480721 9.667489248021965e-08 -0.09975321884261987 +2.204 0.706671197497549 0.7066698572995787 9.597415972714685e-08 -0.09975329371766531 +2.2041 0.7066713313846724 0.7066699882188441 9.524159120047337e-08 -0.09975336857002125 +2.2042 0.7066714652233907 0.7066701191062199 9.447736532344764e-08 -0.09975344339969447 +2.2043000000000004 0.7066715990133785 0.7066702499620559 9.368166779821774e-08 -0.09975351820669186 +2.2044 0.7066717327543125 0.7066703807866999 9.285469150174808e-08 -0.09975359299102028 +2.2045 0.7066718664458715 0.7066705115804972 9.199663646153322e-08 -0.0997536677526866 +2.2046 0.7066720000877367 0.7066706423437914 9.110770983478123e-08 -0.09975374249169768 +2.2047000000000003 0.7066721336795914 0.7066707730769233 9.018812578698299e-08 -0.09975381720806036 +2.2048 0.706672267221121 0.7066709037802312 8.923810553007616e-08 -0.09975389190178147 +2.2049000000000003 0.7066724007120139 0.7066710344540514 8.825787718713674e-08 -0.09975396657286784 +2.205 0.7066725341519606 0.7066711650987175 8.724767580278736e-08 -0.0997540412213263 +2.2051 0.7066726675406547 0.7066712957145602 8.620774324605285e-08 -0.09975411584716375 +2.2052000000000005 0.7066728008777919 0.7066714263019078 8.513832815137956e-08 -0.09975419045038697 +2.2053000000000003 0.7066729341630713 0.7066715568610861 8.403968591343125e-08 -0.09975426503100282 +2.2054 0.7066730673961941 0.7066716873924175 8.291207854137228e-08 -0.09975433958901815 +2.2055 0.7066732005768647 0.7066718178962217 8.175577466927597e-08 -0.09975441412443972 +2.2056 0.706673333704791 0.7066719483728157 8.057104945898008e-08 -0.0997544886372745 +2.2057 0.7066734667796832 0.7066720788225129 7.935818453763677e-08 -0.09975456312752921 +2.2058 0.7066735998012548 0.7066722092456243 7.811746793526253e-08 -0.09975463759521068 +2.2059 0.7066737327692221 0.7066723396424577 7.684919400494095e-08 -0.09975471204032577 +2.206 0.7066738656833056 0.7066724700133168 7.555366337771985e-08 -0.09975478646288127 +2.2060999999999997 0.7066739985432283 0.7066726003585027 7.423118286373209e-08 -0.09975486086288403 +2.2062000000000004 0.706674131348717 0.7066727306783127 7.288206539321496e-08 -0.09975493524034085 +2.2063 0.7066742640995016 0.7066728609730413 7.150662995232537e-08 -0.09975500959525854 +2.2064 0.7066743967953157 0.706672991242979 7.010520148773014e-08 -0.09975508392764394 +2.2065 0.7066745294358964 0.7066731214884128 6.867811084415587e-08 -0.09975515823750385 +2.2066 0.7066746620209842 0.7066732517096259 6.722569466204031e-08 -0.09975523252484503 +2.2067 0.7066747945503237 0.7066733819068984 6.574829534804205e-08 -0.09975530678967436 +2.2068000000000003 0.706674927023663 0.7066735120805061 6.424626095360986e-08 -0.09975538103199859 +2.2069 0.706675059440754 0.7066736422307212 6.271994508304235e-08 -0.09975545525182453 +2.207 0.7066751918013526 0.706673772357812 6.116970685879353e-08 -0.09975552944915904 +2.2071 0.7066753241052184 0.706673902462043 5.9595910784429607e-08 -0.09975560362400887 +2.2072000000000003 0.706675456352115 0.7066740325436744 5.799892670993456e-08 -0.09975567777638081 +2.2073 0.7066755885418103 0.7066741626029627 5.637912969293224e-08 -0.09975575190628165 +2.2074000000000003 0.7066757206740761 0.7066742926401599 5.473689994837938e-08 -0.09975582601371819 +2.2075 0.7066758527486885 0.7066744226555144 5.307262274448221e-08 -0.09975590009869727 +2.2076 0.7066759847654274 0.7066745526492701 5.138668831422555e-08 -0.09975597416122564 +2.2077000000000004 0.7066761167240773 0.7066746826216667 4.967949177384079e-08 -0.09975604820131008 +2.2078 0.7066762486244269 0.7066748125729392 4.795143300657945e-08 -0.09975612221895738 +2.2079 0.706676380466269 0.706674942503319 4.620291658985476e-08 -0.09975619621417432 +2.208 0.7066765122494014 0.7066750724130326 4.44343516998319e-08 -0.0997562701869677 +2.2081 0.7066766439736261 0.7066752023023022 4.2646151998670945e-08 -0.09975634413734434 +2.2082 0.706676775638749 0.7066753321713453 4.083873555993378e-08 -0.09975641806531092 +2.2083000000000004 0.7066769072445811 0.7066754620203746 3.901252475062289e-08 -0.09975649197087422 +2.2084 0.7066770387909381 0.7066755918495992 3.716794615138408e-08 -0.09975656585404104 +2.2085 0.7066771702776402 0.7066757216592228 3.530543044374945e-08 -0.09975663971481823 +2.2086 0.7066773017045123 0.7066758514494447 3.342541230952345e-08 -0.09975671355321246 +2.2087000000000003 0.7066774330713834 0.7066759812204593 3.15283303457814e-08 -0.09975678736923055 +2.2088 0.706677564378088 0.7066761109724561 2.961462693823469e-08 -0.09975686116287923 +2.2089000000000003 0.7066776956244654 0.7066762407056201 2.7684748174494622e-08 -0.09975693493416524 +2.209 0.706677826810359 0.7066763704201316 2.5739143738254255e-08 -0.0997570086830954 +2.2091 0.7066779579356179 0.7066765001161657 2.3778266791327218e-08 -0.09975708240967641 +2.2092 0.7066780890000958 0.7066766297938927 2.1802573895585153e-08 -0.09975715611391511 +2.2093000000000003 0.7066782200036508 0.706676759453478 1.981252488458818e-08 -0.09975722979581815 +2.2094 0.7066783509461471 0.7066768890950816 1.780858275429731e-08 -0.09975730345539235 +2.2095 0.7066784818274527 0.7066770187188591 1.5791213567664664e-08 -0.09975737709264443 +2.2096 0.7066786126474417 0.706677148324961 1.3760886347947976e-08 -0.09975745070758113 +2.2097 0.7066787434059925 0.7066772779135324 1.1718072952075775e-08 -0.09975752430020923 +2.2098 0.706678874102989 0.7066774074847133 9.663247987380663e-09 -0.0997575978705355 +2.2099 0.7066790047383198 0.7066775370386389 7.59688867108671e-09 -0.09975767141856658 +2.21 0.7066791353118793 0.7066776665754388 5.519474743573283e-09 -0.09975774494430929 +2.2100999999999997 0.7066792658235667 0.7066777960952378 3.431488353883294e-09 -0.09975781844777036 +2.2102000000000004 0.7066793962732862 0.7066779255981555 1.3334139278842194e-09 -0.09975789192895651 +2.2103 0.7066795266609478 0.7066780550843057 -7.742619167333542e-10 -0.09975796538787449 +2.2104 0.7066796569864662 0.7066781845537978 -2.89105050142735e-09 -0.09975803882453105 +2.2105 0.7066797872497612 0.7066783140067354 -5.016461191754973e-09 -0.09975811223893283 +2.2106 0.706679917450759 0.7066784434432167 -7.150001517068627e-09 -0.09975818563108668 +2.2107 0.7066800475893897 0.7066785728633349 -9.291177282405583e-09 -0.09975825900099926 +2.2108000000000003 0.7066801776655898 0.7066787022671779 -1.1439492674306107e-08 -0.0997583323486773 +2.2109 0.7066803076793005 0.7066788316548275 -1.359445038961668e-08 -0.09975840567412747 +2.211 0.7066804376304683 0.7066789610263614 -1.575555174477758e-08 -0.09975847897735654 +2.2111 0.706680567519046 0.7066790903818511 -1.7922296785977815e-08 -0.09975855225837127 +2.2112000000000003 0.7066806973449907 0.7066792197213627 -2.0094184414055222e-08 -0.09975862551717832 +2.2113 0.7066808271082655 0.7066793490449574 -2.2270712491181954e-08 -0.09975869875378446 +2.2114000000000003 0.7066809568088386 0.7066794783526905 -2.4451377964029852e-08 -0.09975877196819632 +2.2115 0.7066810864466837 0.7066796076446118 -2.6635676976093786e-08 -0.09975884516042065 +2.2116 0.7066812160217798 0.7066797369207665 -2.8823104985869694e-08 -0.09975891833046417 +2.2117000000000004 0.7066813455341115 0.7066798661811933 -3.101315688221369e-08 -0.09975899147833354 +2.2118 0.7066814749836691 0.7066799954259264 -3.320532710382115e-08 -0.09975906460403552 +2.2119 0.7066816043704476 0.7066801246549941 -3.539910974873113e-08 -0.09975913770757681 +2.212 0.706681733694448 0.7066802538684192 -3.7593998700093806e-08 -0.0997592107889641 +2.2121 0.7066818629556764 0.7066803830662189 -3.978948773632543e-08 -0.09975928384820403 +2.2122 0.7066819921541445 0.7066805122484057 -4.198507065069582e-08 -0.09975935688530332 +2.2123000000000004 0.7066821212898698 0.706680641414986 -4.418024136743288e-08 -0.09975942990026873 +2.2124 0.7066822503628746 0.706680770565961 -4.637449405877573e-08 -0.0997595028931069 +2.2125 0.7066823793731868 0.7066808997013263 -4.856732325943941e-08 -0.0997595758638245 +2.2126 0.7066825083208398 0.7066810288210723 -5.0758223986229443e-08 -0.09975964881242826 +2.2127000000000003 0.7066826372058725 0.7066811579251839 -5.294669185203216e-08 -0.09975972173892483 +2.2128 0.7066827660283289 0.7066812870136405 -5.5132223182163126e-08 -0.09975979464332088 +2.2129000000000003 0.706682894788259 0.7066814160864164 -5.731431512961786e-08 -0.09975986752562316 +2.213 0.7066830234857177 0.7066815451434801 -5.949246579444248e-08 -0.09975994038583834 +2.2131 0.706683152120765 0.7066816741847952 -6.166617433443072e-08 -0.09976001322397307 +2.2132 0.7066832806934669 0.7066818032103193 -6.383494108221782e-08 -0.099760086040034 +2.2133000000000003 0.7066834092038944 0.7066819322200049 -6.599826766172379e-08 -0.09976015883402783 +2.2134 0.706683537652124 0.7066820612137998 -6.815565709722415e-08 -0.0997602316059613 +2.2135 0.7066836660382372 0.7066821901916454 -7.030661393521431e-08 -0.09976030435584095 +2.2136 0.706683794362321 0.7066823191534785 -7.245064435196236e-08 -0.0997603770836735 +2.2137000000000002 0.7066839226244678 0.7066824480992302 -7.458725626756715e-08 -0.09976044978946562 +2.2138 0.7066840508247751 0.7066825770288271 -7.671595946608795e-08 -0.09976052247322398 +2.2139 0.7066841789633456 0.7066827059421896 -7.883626569615831e-08 -0.09976059513495522 +2.214 0.7066843070402875 0.7066828348392337 -8.094768878981473e-08 -0.09976066777466604 +2.2140999999999997 0.7066844350557137 0.7066829637198696 -8.304974477481991e-08 -0.09976074039236309 +2.2142000000000004 0.7066845630097427 0.7066830925840024 -8.514195198525143e-08 -0.09976081298805299 +2.2143 0.7066846909024977 0.7066832214315324 -8.722383116471777e-08 -0.09976088556174238 +2.2144 0.7066848187341079 0.7066833502623546 -8.929490558952369e-08 -0.09976095811343799 +2.2145 0.7066849465047065 0.7066834790763589 -9.135470116147792e-08 -0.0997610306431464 +2.2146 0.7066850742144323 0.7066836078734301 -9.34027465301912e-08 -0.0997611031508743 +2.2147 0.7066852018634289 0.7066837366534481 -9.543857320149646e-08 -0.09976117563662831 +2.2148000000000003 0.7066853294518453 0.7066838654162876 -9.746171562418499e-08 -0.09976124810041509 +2.2149 0.706685456979835 0.7066839941618184 -9.94717113209781e-08 -0.09976132054224127 +2.215 0.7066855844475566 0.7066841228899056 -1.0146810098480424e-07 -0.09976139296211348 +2.2151 0.7066857118551736 0.706684251600409 -1.0345042857160675e-07 -0.09976146536003838 +2.2152000000000003 0.7066858392028544 0.706684380293184 -1.0541824143391748e-07 -0.09976153773602256 +2.2153 0.7066859664907722 0.7066845089680809 -1.0737109039371528e-07 -0.09976161009007271 +2.2154000000000003 0.7066860937191051 0.7066846376249452 -1.0930852985605033e-07 -0.09976168242219544 +2.2155 0.7066862208880353 0.7066847662636173 -1.1123011792180115e-07 -0.09976175473239735 +2.2156 0.7066863479977505 0.706684894883934 -1.1313541647094139e-07 -0.09976182702068509 +2.2157000000000004 0.7066864750484427 0.7066850234857267 -1.1502399126922525e-07 -0.09976189928706532 +2.2158 0.7066866020403086 0.7066851520688219 -1.1689541207400567e-07 -0.09976197153154463 +2.2159 0.7066867289735493 0.7066852806330419 -1.187492527227052e-07 -0.09976204375412964 +2.216 0.7066868558483704 0.7066854091782048 -1.2058509122996053e-07 -0.09976211595482698 +2.2161 0.7066869826649823 0.7066855377041233 -1.224025098934406e-07 -0.09976218813364324 +2.2162 0.7066871094235994 0.7066856662106068 -1.2420109537711332e-07 -0.09976226029058505 +2.2163000000000004 0.706687236124441 0.7066857946974594 -1.2598043881012488e-07 -0.09976233242565906 +2.2164 0.70668736276773 0.7066859231644813 -1.2774013589088307e-07 -0.09976240453887185 +2.2165 0.7066874893536945 0.7066860516114684 -1.2947978695471152e-07 -0.09976247663023004 +2.2166 0.7066876158825659 0.7066861800382122 -1.3119899707619842e-07 -0.09976254869974022 +2.2167000000000003 0.7066877423545803 0.7066863084445 -1.3289737617154518e-07 -0.09976262074740898 +2.2168 0.7066878687699779 0.7066864368301151 -1.3457453907662897e-07 -0.09976269277324294 +2.2169 0.706687995129003 0.7066865651948369 -1.3623010561292226e-07 -0.09976276477724874 +2.217 0.7066881214319038 0.7066866935384405 -1.3786370071759702e-07 -0.09976283675943294 +2.2171 0.7066882476789323 0.706686821860697 -1.3947495450250535e-07 -0.09976290871980216 +2.2172 0.7066883738703447 0.7066869501613737 -1.4106350232530318e-07 -0.09976298065836298 +2.2173000000000003 0.7066885000064009 0.706687078440234 -1.4262898489700304e-07 -0.09976305257512197 +2.2174 0.7066886260873646 0.7066872066970377 -1.4417104836177141e-07 -0.09976312447008573 +2.2175 0.7066887521135035 0.7066873349315406 -1.4568934433856207e-07 -0.0997631963432609 +2.2176 0.7066888780850882 0.706687463143495 -1.4718353006162865e-07 -0.09976326819465403 +2.2177000000000002 0.7066890040023938 0.7066875913326496 -1.486532684221581e-07 -0.09976334002427172 +2.2178 0.7066891298656985 0.7066877194987493 -1.5009822802725115e-07 -0.09976341183212055 +2.2179 0.706689255675284 0.7066878476415357 -1.5151808331267946e-07 -0.09976348361820708 +2.218 0.7066893814314354 0.7066879757607469 -1.5291251459319255e-07 -0.09976355538253791 +2.2180999999999997 0.7066895071344412 0.7066881038561179 -1.54281208130172e-07 -0.0997636271251196 +2.2182000000000004 0.7066896327845935 0.7066882319273802 -1.5562385623051067e-07 -0.09976369884595876 +2.2183 0.706689758382187 0.7066883599742617 -1.5694015729518507e-07 -0.09976377054506193 +2.2184 0.70668988392752 0.706688487996488 -1.5822981586782747e-07 -0.09976384222243569 +2.2185 0.7066900094208939 0.7066886159937806 -1.5949254274748303e-07 -0.09976391387808661 +2.2186 0.7066901348626127 0.7066887439658589 -1.6072805501636533e-07 -0.09976398551202127 +2.2187 0.7066902602529839 0.7066888719124387 -1.619360761005717e-07 -0.09976405712424623 +2.2188000000000003 0.7066903855923177 0.7066889998332331 -1.6311633587069718e-07 -0.09976412871476803 +2.2189 0.706690510880927 0.7066891277279524 -1.642685706695901e-07 -0.09976420028359329 +2.219 0.7066906361191274 0.7066892555963042 -1.653925233713327e-07 -0.0997642718307285 +2.2191 0.7066907613072374 0.706689383437993 -1.6648794344889528e-07 -0.09976434335618023 +2.2192000000000003 0.7066908864455779 0.7066895112527216 -1.6755458704352522e-07 -0.09976441485995508 +2.2193 0.7066910115344727 0.7066896390401893 -1.6859221697515525e-07 -0.09976448634205955 +2.2194000000000003 0.7066911365742474 0.7066897668000937 -1.6960060283434386e-07 -0.09976455780250025 +2.2195 0.7066912615652305 0.7066898945321294 -1.7057952103258223e-07 -0.09976462924128371 +2.2196 0.7066913865077527 0.7066900222359889 -1.715287548283151e-07 -0.09976470065841643 +2.2197000000000005 0.7066915114021469 0.7066901499113627 -1.7244809439112552e-07 -0.09976477205390503 +2.2198 0.7066916362487484 0.7066902775579386 -1.73337336845103e-07 -0.09976484342775603 +2.2199 0.7066917610478941 0.7066904051754027 -1.7419628631568096e-07 -0.09976491477997596 +2.22 0.7066918857999233 0.7066905327634392 -1.7502475395045347e-07 -0.09976498611057133 +2.2201 0.7066920105051768 0.70669066032173 -1.7582255800938085e-07 -0.09976505741954872 +2.2202 0.7066921351639983 0.7066907878499554 -1.7658952385091187e-07 -0.09976512870691473 +2.2203000000000004 0.706692259776732 0.7066909153477938 -1.7732548400484216e-07 -0.09976519997267579 +2.2204 0.7066923843437245 0.7066910428149216 -1.7803027821047812e-07 -0.09976527121683844 +2.2205 0.7066925088653238 0.7066911702510139 -1.7870375340969802e-07 -0.09976534243940922 +2.2206 0.7066926333418797 0.7066912976557446 -1.7934576383368817e-07 -0.09976541364039473 +2.2207000000000003 0.7066927577737432 0.7066914250287855 -1.7995617098906513e-07 -0.09976548481980141 +2.2208 0.706692882161267 0.7066915523698067 -1.8053484373767303e-07 -0.09976555597763584 +2.2209 0.7066930065048047 0.7066916796784782 -1.8108165826188904e-07 -0.09976562711390448 +2.221 0.7066931308047113 0.7066918069544676 -1.815964981444207e-07 -0.09976569822861388 +2.2211 0.7066932550613432 0.7066919341974423 -1.8207925438218364e-07 -0.09976576932177057 +2.2212 0.7066933792750576 0.7066920614070675 -1.825298253793628e-07 -0.09976584039338106 +2.2213000000000003 0.706693503446213 0.7066921885830084 -1.8294811698210678e-07 -0.09976591144345191 +2.2214 0.7066936275751684 0.7066923157249287 -1.833340425444474e-07 -0.09976598247198958 +2.2215 0.7066937516622838 0.7066924428324919 -1.8368752287972745e-07 -0.09976605347900058 +2.2216 0.7066938757079199 0.7066925699053597 -1.840084862952951e-07 -0.09976612446449144 +2.2217000000000002 0.7066939997124381 0.7066926969431937 -1.8429686862372896e-07 -0.0997661954284686 +2.2218 0.7066941236762008 0.7066928239456551 -1.845526132367159e-07 -0.09976626637093866 +2.2219 0.7066942475995702 0.7066929509124046 -1.8477567104158155e-07 -0.09976633729190805 +2.222 0.7066943714829097 0.706693077843102 -1.8496600047782086e-07 -0.09976640819138334 +2.2220999999999997 0.7066944953265826 0.7066932047374068 -1.8512356756220094e-07 -0.099766479069371 +2.2222000000000004 0.706694619130952 0.7066933315949788 -1.8524834586794436e-07 -0.0997665499258775 +2.2223 0.7066947428963819 0.706693458415477 -1.8534031652472915e-07 -0.09976662076090935 +2.2224 0.7066948666232366 0.7066935851985606 -1.8539946824297493e-07 -0.09976669157447304 +2.2225 0.7066949903118795 0.7066937119438887 -1.8542579729302622e-07 -0.0997667623665751 +2.2226 0.7066951139626751 0.7066938386511206 -1.854193075086219e-07 -0.09976683313722201 +2.2227 0.7066952375759863 0.7066939653199151 -1.8538001029730355e-07 -0.0997669038864202 +2.2228000000000003 0.7066953611521773 0.7066940919499323 -1.8530792461959877e-07 -0.09976697461417625 +2.2229 0.7066954846916109 0.7066942185408311 -1.8520307698208227e-07 -0.09976704532049652 +2.223 0.7066956081946503 0.7066943450922722 -1.8506550144084533e-07 -0.09976711600538757 +2.2231 0.7066957316616573 0.7066944716039161 -1.8489523959108745e-07 -0.09976718666885585 +2.2232000000000003 0.7066958550929943 0.706694598075424 -1.846923405393608e-07 -0.09976725731090785 +2.2233 0.7066959784890221 0.7066947245064578 -1.8445686090010072e-07 -0.09976732793155008 +2.2234000000000003 0.7066961018501015 0.7066948508966797 -1.8418886478521745e-07 -0.09976739853078898 +2.2235 0.706696225176592 0.7066949772457529 -1.838884237902183e-07 -0.09976746910863105 +2.2236 0.7066963484688524 0.7066951035533415 -1.8355561695257427e-07 -0.09976753966508267 +2.2237000000000005 0.7066964717272408 0.7066952298191108 -1.83190530758659e-07 -0.09976761020015043 +2.2238 0.7066965949521139 0.7066953560427265 -1.827932590951764e-07 -0.09976768071384069 +2.2239 0.7066967181438275 0.7066954822238559 -1.823639032456914e-07 -0.09976775120615998 +2.224 0.7066968413027364 0.7066956083621672 -1.8190257185246583e-07 -0.09976782167711475 +2.2241 0.7066969644291936 0.7066957344573299 -1.814093809060502e-07 -0.09976789212671143 +2.2242 0.7066970875235514 0.7066958605090152 -1.808844537140586e-07 -0.09976796255495651 +2.2243000000000004 0.7066972105861602 0.7066959865168954 -1.8032792083871874e-07 -0.09976803296185645 +2.2244 0.706697333617369 0.7066961124806439 -1.7973992010034134e-07 -0.09976810334741769 +2.2245 0.7066974566175251 0.7066962383999364 -1.7912059652527845e-07 -0.09976817371164666 +2.2245999999999997 0.706697579586975 0.7066963642744499 -1.7847010232510674e-07 -0.09976824405454986 +2.2247000000000003 0.7066977025260626 0.7066964901038628 -1.7778859683764692e-07 -0.0997683143761337 +2.2248 0.7066978254351299 0.706696615887856 -1.7707624651308596e-07 -0.09976838467640466 +2.2249 0.7066979483145178 0.7066967416261116 -1.7633322485499647e-07 -0.09976845495536917 +2.225 0.7066980711645645 0.706696867318314 -1.7555971238564227e-07 -0.09976852521303366 +2.2251 0.7066981939856067 0.7066969929641497 -1.7475589659393664e-07 -0.09976859544940458 +2.2252 0.7066983167779785 0.7066971185633069 -1.7392197191115621e-07 -0.09976866566448833 +2.2253000000000003 0.7066984395420122 0.7066972441154764 -1.7305813963808259e-07 -0.09976873585829141 +2.2254 0.7066985622780377 0.706697369620351 -1.7216460791551202e-07 -0.09976880603082022 +2.2255 0.7066986849863827 0.7066974950776261 -1.7124159165833597e-07 -0.0997688761820812 +2.2256 0.7066988076673721 0.7066976204869988 -1.7028931252084656e-07 -0.09976894631208076 +2.2257000000000002 0.7066989303213291 0.7066977458481697 -1.6930799883949077e-07 -0.09976901642082536 +2.2258 0.7066990529485738 0.7066978711608409 -1.6829788555480785e-07 -0.09976908650832145 +2.2259 0.7066991755494236 0.7066979964247178 -1.6725921419928624e-07 -0.09976915657457536 +2.226 0.706699298124194 0.7066981216395081 -1.6619223280368856e-07 -0.09976922661959364 +2.2260999999999997 0.7066994206731965 0.7066982468049223 -1.6509719584847926e-07 -0.09976929664338259 +2.2262000000000004 0.7066995431967409 0.706698371920674 -1.639743641961705e-07 -0.09976936664594874 +2.2263 0.7066996656951333 0.7066984969864792 -1.6282400505142347e-07 -0.09976943662729842 +2.2264 0.7066997881686776 0.7066986220020574 -1.6164639188472052e-07 -0.09976950658743806 +2.2265 0.7066999106176743 0.7066987469671305 -1.6044180435430266e-07 -0.09976957652637414 +2.2266 0.7067000330424207 0.7066988718814239 -1.592105282575973e-07 -0.09976964644411297 +2.2267 0.7067001554432112 0.706698996744666 -1.579528554514209e-07 -0.09976971634066105 +2.2268000000000003 0.7067002778203368 0.7066991215565885 -1.5666908380340683e-07 -0.09976978621602474 +2.2269 0.7067004001740853 0.7066992463169264 -1.5535951708792184e-07 -0.09976985607021045 +2.227 0.7067005225047414 0.7066993710254176 -1.5402446494443278e-07 -0.0997699259032246 +2.2271 0.7067006448125858 0.7066994956818038 -1.526642427977093e-07 -0.09976999571507357 +2.2272000000000003 0.7067007670978964 0.7066996202858302 -1.5127917177976125e-07 -0.09977006550576378 +2.2273 0.7067008893609472 0.7066997448372454 -1.4986957863616368e-07 -0.09977013527530164 +2.2274000000000003 0.7067010116020088 0.7066998693358013 -1.4843579567748455e-07 -0.09977020502369352 +2.2275 0.7067011338213478 0.7066999937812539 -1.4697816069775271e-07 -0.09977027475094578 +2.2276 0.7067012560192276 0.7067001181733625 -1.4549701687731342e-07 -0.09977034445706484 +2.2277000000000005 0.7067013781959077 0.7067002425118909 -1.439927126995616e-07 -0.09977041414205717 +2.2278000000000002 0.7067015003516435 0.7067003667966053 -1.4246560190930846e-07 -0.09977048380592907 +2.2279 0.7067016224866869 0.7067004910272772 -1.409160433930856e-07 -0.09977055344868696 +2.228 0.7067017446012855 0.706700615203681 -1.3934440108546997e-07 -0.0997706230703372 +2.2281 0.7067018666956835 0.706700739325596 -1.3775104392051152e-07 -0.09977069267088622 +2.2282 0.7067019887701202 0.7067008633928042 -1.3613634571897626e-07 -0.09977076225034029 +2.2283000000000004 0.7067021108248319 0.7067009874050931 -1.345006851120184e-07 -0.09977083180870588 +2.2284 0.7067022328600501 0.7067011113622533 -1.3284444544230112e-07 -0.09977090134598937 +2.2285 0.7067023548760019 0.7067012352640804 -1.3116801467899508e-07 -0.09977097086219713 +2.2285999999999997 0.7067024768729109 0.7067013591103732 -1.2947178533451176e-07 -0.09977104035733551 +2.2287000000000003 0.7067025988509958 0.7067014829009357 -1.277561543690936e-07 -0.0997711098314109 +2.2288 0.7067027208104715 0.7067016066355757 -1.260215230902001e-07 -0.09977117928442963 +2.2289 0.706702842751548 0.7067017303141054 -1.242682970588327e-07 -0.09977124871639813 +2.229 0.7067029646744312 0.7067018539363419 -1.2249688601147224e-07 -0.09977131812732268 +2.2291 0.7067030865793225 0.706701977502106 -1.2070770374732198e-07 -0.09977138751720972 +2.2292 0.7067032084664189 0.7067021010112234 -1.1890116803463247e-07 -0.09977145688606559 +2.2293000000000003 0.7067033303359128 0.7067022244635244 -1.1707770051355704e-07 -0.09977152623389667 +2.2294 0.7067034521879918 0.7067023478588437 -1.1523772660594622e-07 -0.09977159556070928 +2.2295 0.7067035740228393 0.7067024711970205 -1.1338167541473376e-07 -0.0997716648665098 +2.2296 0.7067036958406339 0.7067025944778988 -1.1150997961291431e-07 -0.09977173415130458 +2.2297000000000002 0.7067038176415489 0.7067027177013274 -1.096230753377253e-07 -0.09977180341509995 +2.2298 0.7067039394257538 0.7067028408671598 -1.0772140211605385e-07 -0.09977187265790227 +2.2299 0.706704061193413 0.706702963975254 -1.0580540275167971e-07 -0.09977194187971794 +2.23 0.7067041829446856 0.7067030870254729 -1.0387552320124255e-07 -0.0997720110805532 +2.2300999999999997 0.706704304679727 0.7067032100176844 -1.0193221248577106e-07 -0.09977208026041451 +2.2302000000000004 0.7067044263986865 0.7067033329517614 -9.997592260307941e-08 -0.09977214941930813 +2.2303 0.7067045481017092 0.7067034558275809 -9.800710839506094e-08 -0.09977221855724047 +2.2304 0.7067046697889351 0.7067035786450255 -9.602622745401301e-08 -0.0997722876742178 +2.2305 0.7067047914604995 0.7067037014039826 -9.403374001681897e-08 -0.0997723567702465 +2.2306 0.7067049131165322 0.7067038241043444 -9.203010885652785e-08 -0.09977242584533286 +2.2307 0.7067050347571585 0.7067039467460084 -9.001579917740365e-08 -0.09977249489948326 +2.2308000000000003 0.7067051563824984 0.7067040693288771 -8.799127850563776e-08 -0.09977256393270398 +2.2309 0.7067052779926669 0.7067041918528576 -8.595701657052035e-08 -0.09977263294500141 +2.231 0.7067053995877742 0.7067043143178626 -8.391348521857162e-08 -0.09977270193638188 +2.2311 0.706705521167925 0.7067044367238096 -8.18611582808354e-08 -0.09977277090685166 +2.2312000000000003 0.7067056427332189 0.706704559070621 -7.980051147920414e-08 -0.0997728398564171 +2.2313 0.7067057642837504 0.7067046813582247 -7.773202230585557e-08 -0.09977290878508449 +2.2314000000000003 0.7067058858196096 0.706704803586554 -7.565616991483254e-08 -0.09977297769286023 +2.2315 0.70670600734088 0.7067049257555464 -7.357343501969427e-08 -0.0997730465797505 +2.2316 0.7067061288476413 0.7067050478651457 -7.148429977382048e-08 -0.09977311544576173 +2.2317000000000005 0.706706250339967 0.7067051699153 -6.9389247656787e-08 -0.09977318429090021 +2.2318000000000002 0.7067063718179265 0.7067052919059632 -6.728876336507816e-08 -0.0997732531151723 +2.2319 0.7067064932815825 0.7067054138370941 -6.518333270713605e-08 -0.09977332191858423 +2.232 0.7067066147309937 0.7067055357086568 -6.307344248279723e-08 -0.09977339070114234 +2.2321 0.7067067361662129 0.7067056575206205 -6.095958036923463e-08 -0.09977345946285293 +2.2322 0.7067068575872879 0.7067057792729601 -5.884223481730788e-08 -0.09977352820372233 +2.2323000000000004 0.7067069789942613 0.7067059009656552 -5.6721894931216835e-08 -0.0997735969237568 +2.2324 0.7067071003871701 0.7067060225986908 -5.4599050358129786e-08 -0.09977366562296264 +2.2325 0.7067072217660466 0.7067061441720575 -5.2474191176076976e-08 -0.09977373430134619 +2.2325999999999997 0.7067073431309174 0.7067062656857505 -5.0347807777724116e-08 -0.09977380295891372 +2.2327000000000004 0.7067074644818041 0.706706387139771 -4.8220390759783766e-08 -0.09977387159567155 +2.2328 0.7067075858187224 0.7067065085341251 -4.6092430809065686e-08 -0.09977394021162594 +2.2329 0.7067077071416837 0.7067066298688242 -4.3964418591400326e-08 -0.09977400880678323 +2.233 0.7067078284506932 0.7067067511438849 -4.183684463479571e-08 -0.09977407738114964 +2.2331 0.7067079497457514 0.706706872359329 -3.9710199218896246e-08 -0.09977414593473148 +2.2332 0.7067080710268536 0.7067069935151838 -3.758497226164295e-08 -0.09977421446753504 +2.2333000000000003 0.7067081922939895 0.7067071146114818 -3.546165320579813e-08 -0.09977428297956664 +2.2334 0.7067083135471435 0.7067072356482608 -3.334073090765881e-08 -0.09977435147083252 +2.2335 0.7067084347862951 0.7067073566255633 -3.1222693524374234e-08 -0.09977441994133893 +2.2336 0.7067085560114186 0.7067074775434377 -2.910802839842415e-08 -0.09977448839109224 +2.2337000000000002 0.7067086772224827 0.7067075984019373 -2.6997221949740663e-08 -0.09977455682009867 +2.2338 0.706708798419451 0.7067077192011207 -2.489075956110809e-08 -0.09977462522836451 +2.2339 0.706708919602282 0.7067078399410518 -2.2789125469959565e-08 -0.09977469361589601 +2.234 0.7067090407709291 0.7067079606217992 -2.069280265193374e-08 -0.09977476198269944 +2.2340999999999998 0.7067091619253403 0.7067080812434372 -1.860227271440612e-08 -0.0997748303287811 +2.2342000000000004 0.7067092830654584 0.706708201806045 -1.651801578373205e-08 -0.09977489865414718 +2.2343 0.7067094041912216 0.706708322309707 -1.4440510395091755e-08 -0.09977496695880407 +2.2344 0.7067095253025623 0.7067084427545127 -1.2370233384503826e-08 -0.09977503524275791 +2.2345 0.7067096463994083 0.7067085631405569 -1.0307659779537626e-08 -0.09977510350601505 +2.2346 0.7067097674816819 0.7067086834679389 -8.253262685255225e-09 -0.0997751717485817 +2.2347 0.7067098885493008 0.7067088037367637 -6.207513177092228e-09 -0.09977523997046417 +2.2348000000000003 0.7067100096021772 0.7067089239471411 -4.170880201111171e-09 -0.09977530817166869 +2.2349 0.7067101306402186 0.7067090440991854 -2.143830459509777e-09 -0.09977537635220146 +2.235 0.7067102516633272 0.706709164193017 -1.2682830220073216e-10 -0.09977544451206877 +2.2351 0.7067103726714007 0.7067092842287598 1.87966437380227e-09 -0.09977551265127685 +2.2352000000000003 0.7067104936643316 0.7067094042065439 3.875188239743643e-09 -0.09977558076983195 +2.2353 0.7067106146420075 0.7067095241265038 5.859286622729443e-09 -0.09977564886774037 +2.2354000000000003 0.7067107356043112 0.7067096439887788 7.831505630627456e-09 -0.09977571694500832 +2.2355 0.7067108565511208 0.7067097637935131 9.791394240538098e-09 -0.09977578500164207 +2.2356 0.706710977482309 0.7067098835408556 1.173850441502089e-08 -0.09977585303764779 +2.2357000000000005 0.7067110983977445 0.7067100032309603 1.3672391190565347e-08 -0.0997759210530318 +2.2358000000000002 0.7067112192972907 0.7067101228639856 1.5592612789480653e-08 -0.0997759890478003 +2.2359 0.7067113401808065 0.7067102424400946 1.7498730714438082e-08 -0.09977605702195949 +2.236 0.706711461048146 0.7067103619594551 1.9390309850819687e-08 -0.0997761249755156 +2.2361 0.706711581899159 0.7067104814222399 2.1266918569066984e-08 -0.09977619290847493 +2.2362 0.7067117027336904 0.7067106008286259 2.3128128821825467e-08 -0.09977626082084369 +2.2363000000000004 0.7067118235515808 0.7067107201787947 2.4973516242823846e-08 -0.09977632871262805 +2.2364 0.7067119443526656 0.7067108394729322 2.6802660226671327e-08 -0.09977639658383425 +2.2365 0.706712065136777 0.7067109587112297 2.8615144051155617e-08 -0.0997764644344686 +2.2365999999999997 0.7067121859037415 0.7067110778938815 3.041055495443812e-08 -0.09977653226453721 +2.2367000000000004 0.706712306653382 0.7067111970210875 3.2188484242606785e-08 -0.09977660007404641 +2.2368 0.7067124273855165 0.7067113160930513 3.3948527366003955e-08 -0.09977666786300232 +2.2369 0.706712548099959 0.7067114351099808 3.569028402851393e-08 -0.09977673563141114 +2.237 0.7067126687965195 0.7067115540720884 3.7413358258686635e-08 -0.0997768033792792 +2.2371 0.7067127894750036 0.7067116729795904 3.91173585190252e-08 -0.09977687110661262 +2.2372 0.7067129101352128 0.7067117918327075 4.080189779098742e-08 -0.09977693881341765 +2.2373000000000003 0.7067130307769438 0.7067119106316644 4.2466593646109385e-08 -0.09977700649970045 +2.2374 0.7067131513999905 0.7067120293766899 4.411106835182366e-08 -0.09977707416546733 +2.2375 0.7067132720041418 0.7067121480680166 4.57349489425829e-08 -0.09977714181072439 +2.2376 0.7067133925891831 0.7067122667058812 4.733786732741274e-08 -0.09977720943547787 +2.2377000000000002 0.7067135131548958 0.7067123852905244 4.8919460354096556e-08 -0.09977727703973398 +2.2378 0.7067136337010578 0.7067125038221904 5.047936989244217e-08 -0.09977734462349891 +2.2379000000000002 0.7067137542274421 0.7067126223011276 5.2017242908874994e-08 -0.09977741218677884 +2.238 0.7067138747338194 0.7067127407275876 5.3532731568786684e-08 -0.09977747972957997 +2.2380999999999998 0.7067139952199559 0.7067128591018262 5.502549329725048e-08 -0.09977754725190853 +2.2382000000000004 0.7067141156856144 0.7067129774241026 5.6495190867492107e-08 -0.09977761475377067 +2.2383 0.7067142361305538 0.7067130956946793 5.7941492468543965e-08 -0.09977768223517261 +2.2384 0.7067143565545303 0.7067132139138228 5.93640717746341e-08 -0.09977774969612052 +2.2385 0.706714476957296 0.7067133320818024 6.07626080284529e-08 -0.09977781713662055 +2.2386 0.7067145973385996 0.7067134501988916 6.213678611748097e-08 -0.09977788455667902 +2.2387 0.706714717698187 0.7067135682653665 6.348629662950023e-08 -0.09977795195630196 +2.2388000000000003 0.7067148380358004 0.7067136862815065 6.481083595667736e-08 -0.09977801933549563 +2.2389 0.7067149583511786 0.7067138042475946 6.611010631117631e-08 -0.09977808669426617 +2.239 0.7067150786440579 0.7067139221639165 6.738381582577224e-08 -0.09977815403261978 +2.2391 0.7067151989141713 0.7067140400307612 6.863167861803632e-08 -0.09977822135056261 +2.2392000000000003 0.7067153191612487 0.7067141578484205 6.985341484411212e-08 -0.09977828864810084 +2.2393 0.7067154393850172 0.7067142756171896 7.104875078198236e-08 -0.09977835592524066 +2.2394000000000003 0.7067155595852006 0.7067143933373659 7.221741886095923e-08 -0.09977842318198826 +2.2395 0.7067156797615206 0.7067145110092501 7.335915774321633e-08 -0.09977849041834976 +2.2396 0.7067157999136957 0.7067146286331454 7.447371237062628e-08 -0.09977855763433136 +2.2397000000000005 0.7067159200414419 0.7067147462093577 7.556083403414959e-08 -0.09977862482993921 +2.2398000000000002 0.7067160401444725 0.7067148637381953 7.662028043628477e-08 -0.09977869200517941 +2.2399 0.7067161602224985 0.7067149812199693 7.765181571882385e-08 -0.0997787591600583 +2.24 0.706716280275228 0.7067150986549932 7.865521052530244e-08 -0.09977882629458182 +2.2401 0.706716400302367 0.7067152160435827 7.963024206518454e-08 -0.09977889340875624 +2.2402 0.7067165203036194 0.7067153333860561 8.057669413120971e-08 -0.09977896050258774 +2.2403000000000004 0.7067166402786864 0.7067154506827336 8.149435718786402e-08 -0.09977902757608237 +2.2404 0.7067167602272673 0.7067155679339376 8.238302840433975e-08 -0.09977909462924633 +2.2405 0.7067168801490594 0.7067156851399934 8.324251169096464e-08 -0.09977916166208582 +2.2405999999999997 0.7067170000437579 0.7067158023012269 8.407261773216157e-08 -0.09977922867460695 +2.2407000000000004 0.7067171199110559 0.7067159194179669 8.487316405410283e-08 -0.09977929566681581 +2.2408 0.7067172397506445 0.706716036490544 8.5643975031649e-08 -0.09977936263871864 +2.2409 0.7067173595622137 0.7067161535192902 8.638488197681982e-08 -0.09977942959032153 +2.241 0.7067174793454509 0.7067162705045396 8.709572312665115e-08 -0.09977949652163061 +2.2411 0.7067175991000423 0.7067163874466278 8.777634369350196e-08 -0.09977956343265204 +2.2412 0.7067177188256725 0.7067165043458922 8.84265959240349e-08 -0.09977963032339195 +2.2413000000000003 0.7067178385220245 0.7067166212026712 8.904633909054271e-08 -0.09977969719385646 +2.2414 0.7067179581887801 0.706716738017305 8.963543953605102e-08 -0.09977976404405173 +2.2415 0.7067180778256192 0.7067168547901348 9.019377073329893e-08 -0.09977983087398384 +2.2416 0.7067181974322214 0.7067169715215038 9.07212132604529e-08 -0.09977989768365898 +2.2417000000000002 0.7067183170082638 0.7067170882117557 9.121765486702627e-08 -0.09977996447308325 +2.2418 0.7067184365534236 0.7067172048612353 9.168299046694028e-08 -0.09978003124226278 +2.2419000000000002 0.7067185560673761 0.7067173214702891 9.211712220097423e-08 -0.09978009799120365 +2.242 0.7067186755497964 0.7067174380392639 9.251995939166258e-08 -0.09978016471991208 +2.2420999999999998 0.7067187950003577 0.7067175545685075 9.289141863003114e-08 -0.0997802314283941 +2.2422000000000004 0.7067189144187337 0.7067176710583686 9.323142378253602e-08 -0.09978029811665587 +2.2423 0.7067190338045961 0.7067177875091968 9.353990595983852e-08 -0.09978036478470349 +2.2424 0.7067191531576167 0.706717903921342 9.381680357231637e-08 -0.09978043143254309 +2.2425 0.7067192724774661 0.7067180202951548 9.40620623196553e-08 -0.0997804980601807 +2.2426 0.7067193917638155 0.7067181366309866 9.427563522207416e-08 -0.09978056466762254 +2.2427 0.7067195110163346 0.7067182529291887 9.445748260991649e-08 -0.09978063125487467 +2.2428000000000003 0.7067196302346932 0.7067183691901127 9.460757213752835e-08 -0.09978069782194318 +2.2429 0.7067197494185609 0.7067184854141113 9.472587881101391e-08 -0.09978076436883418 +2.243 0.706719868567607 0.7067186016015363 9.481238495354094e-08 -0.09978083089555381 +2.2431 0.7067199876815009 0.7067187177527405 9.486708019840195e-08 -0.09978089740210813 +2.2432000000000003 0.7067201067599116 0.7067188338680761 9.488996155840312e-08 -0.0997809638885033 +2.2433 0.7067202258025085 0.7067189499478954 9.48810333530059e-08 -0.09978103035474536 +2.2434000000000003 0.7067203448089607 0.7067190659925509 9.48403072499604e-08 -0.09978109680084041 +2.2435 0.7067204637789379 0.7067191820023944 9.476780223408032e-08 -0.09978116322679456 +2.2436 0.7067205827121104 0.7067192979777774 9.466354461071247e-08 -0.09978122963261393 +2.2437000000000005 0.7067207016081478 0.7067194139190514 9.452756799532835e-08 -0.09978129601830453 +2.2438000000000002 0.7067208204667214 0.7067195298265672 9.435991331005478e-08 -0.09978136238387247 +2.2439 0.7067209392875021 0.7067196457006752 9.416062876632658e-08 -0.09978142872932393 +2.244 0.7067210580701618 0.7067197615417251 9.392976984060053e-08 -0.09978149505466488 +2.2441 0.7067211768143733 0.7067198773500657 9.36673992743553e-08 -0.0997815613599014 +2.2442 0.7067212955198094 0.7067199931260455 9.337358707756094e-08 -0.09978162764503967 +2.2443 0.7067214141861449 0.7067201088700119 9.304841045928991e-08 -0.09978169391008573 +2.2444 0.706721532813054 0.7067202245823112 9.269195384506435e-08 -0.09978176015504558 +2.2445 0.7067216514002137 0.7067203402632893 9.230430883522267e-08 -0.09978182637992541 +2.2445999999999997 0.7067217699473004 0.7067204559132902 9.188557420491961e-08 -0.09978189258473126 +2.2447000000000004 0.7067218884539925 0.7067205715326574 9.143585585902336e-08 -0.09978195876946915 +2.2448 0.7067220069199693 0.7067206871217329 9.095526682517674e-08 -0.09978202493414517 +2.2449 0.7067221253449121 0.7067208026808574 9.044392720175543e-08 -0.09978209107876544 +2.245 0.7067222437285027 0.7067209182103701 8.990196413705132e-08 -0.09978215720333598 +2.2451 0.7067223620704245 0.706721033710609 8.932951180151694e-08 -0.09978222330786284 +2.2452 0.7067224803703629 0.7067211491819105 8.872671136000987e-08 -0.09978228939235206 +2.2453000000000003 0.7067225986280046 0.7067212646246093 8.809371092322049e-08 -0.09978235545680977 +2.2454 0.7067227168430379 0.7067213800390384 8.743066550950807e-08 -0.099782421501242 +2.2455 0.7067228350151528 0.7067214954255294 8.673773704663545e-08 -0.09978248752565479 +2.2456 0.7067229531440415 0.7067216107844119 8.60150942885024e-08 -0.09978255353005423 +2.2457000000000003 0.7067230712293979 0.7067217261160131 8.526291277004272e-08 -0.09978261951444639 +2.2458 0.7067231892709176 0.7067218414206589 8.448137479855067e-08 -0.09978268547883726 +2.2459000000000002 0.7067233072682985 0.7067219566986727 8.36706693825573e-08 -0.09978275142323292 +2.246 0.7067234252212407 0.7067220719503761 8.283099220060541e-08 -0.09978281734763944 +2.2460999999999998 0.7067235431294461 0.7067221871760884 8.196254556655513e-08 -0.09978288325206282 +2.2462000000000004 0.7067236609926193 0.7067223023761264 8.106553834805186e-08 -0.09978294913650913 +2.2463 0.706723778810467 0.7067224175508051 8.014018594224015e-08 -0.09978301500098441 +2.2464 0.7067238965826981 0.7067225327004368 7.918671020984425e-08 -0.09978308084549474 +2.2465 0.7067240143090243 0.7067226478253312 7.820533942312635e-08 -0.09978314667004609 +2.2466 0.7067241319891596 0.7067227629257956 7.719630822425327e-08 -0.09978321247464451 +2.2467 0.7067242496228208 0.7067228780021346 7.615985754723387e-08 -0.09978327825929606 +2.2468000000000004 0.7067243672097272 0.7067229930546504 7.50962345936329e-08 -0.09978334402400674 +2.2469 0.7067244847496007 0.7067231080836421 7.400569274756963e-08 -0.09978340976878258 +2.247 0.7067246022421664 0.7067232230894065 7.288849151500243e-08 -0.09978347549362965 +2.2471 0.7067247196871519 0.7067233380722371 7.174489647689131e-08 -0.09978354119855398 +2.2472000000000003 0.7067248370842878 0.7067234530324249 7.057517921113532e-08 -0.09978360688356158 +2.2473 0.7067249544333079 0.7067235679702573 6.937961723879615e-08 -0.09978367254865847 +2.2474000000000003 0.7067250717339486 0.7067236828860188 6.815849395297446e-08 -0.09978373819385065 +2.2475 0.7067251889859499 0.7067237977799913 6.691209855115565e-08 -0.0997838038191442 +2.2476 0.706725306189055 0.7067239126524529 6.564072597449455e-08 -0.09978386942454509 +2.2477000000000005 0.7067254233430096 0.706724027503679 6.434467683148759e-08 -0.09978393501005937 +2.2478000000000002 0.7067255404475634 0.706724142333941 6.302425733031858e-08 -0.09978400057569299 +2.2479 0.7067256575024695 0.7067242571435077 6.167977920773504e-08 -0.09978406612145205 +2.248 0.7067257745074838 0.7067243719326441 6.031155964057733e-08 -0.0997841316473425 +2.2481 0.7067258914623662 0.7067244867016118 5.8919921190267455e-08 -0.09978419715337039 +2.2482 0.7067260083668798 0.7067246014506685 5.750519171780766e-08 -0.09978426263954167 +2.2483 0.7067261252207915 0.7067247161800693 5.606770429704422e-08 -0.09978432810586241 +2.2484 0.7067262420238716 0.7067248308900644 5.4607797169564654e-08 -0.09978439355233856 +2.2485 0.7067263587758945 0.706724945580901 5.312581363887958e-08 -0.09978445897897613 +2.2485999999999997 0.706726475476638 0.7067250602528228 5.1622101975012935e-08 -0.09978452438578113 +2.2487000000000004 0.7067265921258838 0.7067251749060692 5.009701537286859e-08 -0.09978458977275963 +2.2488 0.7067267087234177 0.7067252895408758 4.855091183773863e-08 -0.09978465513991754 +2.2489 0.7067268252690289 0.7067254041574744 4.698415410550605e-08 -0.09978472048726088 +2.249 0.7067269417625106 0.706725518756093 4.5397109574990546e-08 -0.09978478581479562 +2.2491 0.7067270582036606 0.7067256333369553 4.379015020039567e-08 -0.0997848511225278 +2.2492 0.7067271745922801 0.706725747900281 4.216365242365461e-08 -0.09978491641046337 +2.2493000000000003 0.7067272909281748 0.7067258624462858 4.05179970807551e-08 -0.09978498167860833 +2.2494 0.7067274072111542 0.7067259769751817 3.8853569299390767e-08 -0.09978504692696871 +2.2495 0.7067275234410324 0.7067260914871751 3.717075841916384e-08 -0.09978511215555042 +2.2496 0.7067276396176274 0.7067262059824699 3.546995790484897e-08 -0.09978517736435949 +2.2497000000000003 0.7067277557407614 0.7067263204612648 3.375156524577927e-08 -0.09978524255340188 +2.2498 0.7067278718102611 0.7067264349237543 3.201598186737542e-08 -0.0997853077226836 +2.2499000000000002 0.7067279878259578 0.7067265493701281 3.026361303920533e-08 -0.09978537287221056 +2.25 0.7067281037876865 0.7067266638005725 2.8494867767431264e-08 -0.0997854380019888 +2.2500999999999998 0.7067282196952873 0.7067267782152685 2.6710158721951482e-08 -0.09978550311202425 +2.2502000000000004 0.7067283355486045 0.7067268926143931 2.4909902125377914e-08 -0.09978556820232291 +2.2503 0.7067284513474869 0.7067270069981186 2.309451765242221e-08 -0.09978563327289072 +2.2504 0.706728567091788 0.7067271213666126 2.1264428351833176e-08 -0.0997856983237337 +2.2505 0.7067286827813659 0.7067272357200386 1.9420060524966143e-08 -0.09978576335485784 +2.2506 0.7067287984160828 0.7067273500585547 1.7561843634709973e-08 -0.09978582836626898 +2.2507 0.7067289139958062 0.7067274643823152 1.5690210206607824e-08 -0.0997858933579732 +2.2508000000000004 0.7067290295204078 0.7067275786914691 1.3805595736049447e-08 -0.09978595832997637 +2.2509 0.7067291449897644 0.7067276929861611 1.1908438567707902e-08 -0.09978602328228453 +2.251 0.7067292604037572 0.7067278072665308 9.999179814007553e-09 -0.0997860882149036 +2.2511 0.7067293757622723 0.7067279215327132 8.078263244101769e-09 -0.09978615312783956 +2.2512000000000003 0.7067294910652007 0.7067280357848387 6.146135178922152e-09 -0.0997862180210983 +2.2513 0.706729606312438 0.7067281500230322 4.203244387095129e-09 -0.09978628289468582 +2.2514000000000003 0.706729721503885 0.7067282642474149 2.250041989532159e-09 -0.09978634774860812 +2.2515 0.706729836639447 0.7067283784581018 2.869813397338161e-10 -0.09978641258287105 +2.2516 0.7067299517190344 0.706728492655204 -1.6854820707526419e-09 -0.09978647739748062 +2.2517000000000005 0.7067300667425622 0.706728606838827 -3.666890716416682e-09 -0.09978654219244273 +2.2518000000000002 0.7067301817099507 0.7067287210090718 -5.6567851531436064e-09 -0.09978660696776333 +2.2519 0.7067302966211253 0.7067288351660346 -7.654704117961153e-09 -0.0997866717234484 +2.252 0.7067304114760158 0.7067289493098061 -9.660184633122904e-09 -0.09978673645950387 +2.2521 0.7067305262745573 0.7067290634404725 -1.1672762121467395e-08 -0.09978680117593568 +2.2522 0.70673064101669 0.7067291775581144 -1.3691970507465762e-08 -0.09978686587274971 +2.2523 0.7067307557023589 0.7067292916628076 -1.5717342330412443e-08 -0.09978693054995193 +2.2524 0.7067308703315143 0.7067294057546236 -1.7748408845906505e-08 -0.09978699520754833 +2.2525 0.706730984904111 0.7067295198336279 -1.9784700142078115e-08 -0.09978705984554473 +2.2525999999999997 0.7067310994201097 0.7067296338998811 -2.182574524367195e-08 -0.09978712446394715 +2.2527000000000004 0.7067312138794755 0.7067297479534389 -2.3871072220033734e-08 -0.09978718906276146 +2.2528 0.7067313282821788 0.7067298619943523 -2.5920208296566216e-08 -0.09978725364199362 +2.2529 0.7067314426281952 0.7067299760226664 -2.7972679964884117e-08 -0.0997873182016496 +2.253 0.706731556917505 0.706730090038422 -3.00280130888491e-08 -0.09978738274173522 +2.2531 0.7067316711500939 0.7067302040416541 -3.208573301385735e-08 -0.09978744726225644 +2.2532 0.7067317853259528 0.706730318032393 -3.414536468133132e-08 -0.09978751176321915 +2.2533000000000003 0.7067318994450775 0.7067304320106638 -3.620643273377893e-08 -0.09978757624462933 +2.2534 0.7067320135074687 0.7067305459764864 -3.826846162733374e-08 -0.09978764070649282 +2.2535 0.706732127513133 0.7067306599298762 -4.0330975738223605e-08 -0.09978770514881563 +2.2536 0.7067322414620811 0.7067307738708427 -4.2393499476286664e-08 -0.09978776957160365 +2.2537000000000003 0.7067323553543297 0.7067308877993903 -4.4455557390423524e-08 -0.09978783397486274 +2.2538 0.7067324691898995 0.7067310017155188 -4.651667428226232e-08 -0.09978789835859879 +2.2539000000000002 0.7067325829688171 0.7067311156192227 -4.857637531270869e-08 -0.0997879627228177 +2.254 0.7067326966911145 0.7067312295104913 -5.063418611250727e-08 -0.09978802706752543 +2.2540999999999998 0.706732810356828 0.706731343389309 -5.2689632891542854e-08 -0.0997880913927279 +2.2542000000000004 0.7067329239659994 0.7067314572556549 -5.474224254627125e-08 -0.09978815569843097 +2.2543 0.7067330375186756 0.706731571109503 -5.6791542771663164e-08 -0.09978821998464053 +2.2544 0.7067331510149082 0.7067316849508225 -5.883706216702235e-08 -0.09978828425136249 +2.2545 0.7067332644547539 0.7067317987795776 -6.087833034559842e-08 -0.09978834849860273 +2.2546 0.7067333778382747 0.7067319125957269 -6.291487804300708e-08 -0.09978841272636713 +2.2547 0.7067334911655381 0.7067320263992246 -6.494623722283141e-08 -0.09978847693466164 +2.2548000000000004 0.7067336044366156 0.7067321401900197 -6.697194118807787e-08 -0.09978854112349213 +2.2549 0.706733717651584 0.706732253968056 -6.899152468417546e-08 -0.09978860529286446 +2.255 0.7067338308105252 0.7067323677332724 -7.10045240121665e-08 -0.09978866944278454 +2.2551 0.7067339439135263 0.7067324814856032 -7.301047712324898e-08 -0.09978873357325826 +2.2552000000000003 0.7067340569606788 0.7067325952249772 -7.500892373760518e-08 -0.09978879768429148 +2.2553 0.7067341699520798 0.7067327089513187 -7.699940544371453e-08 -0.09978886177589014 +2.2554000000000003 0.7067342828878306 0.7067328226645466 -7.898146580503917e-08 -0.09978892584806001 +2.2555 0.7067343957680376 0.7067329363645756 -8.095465046063788e-08 -0.09978898990080705 +2.2556 0.7067345085928123 0.7067330500513149 -8.291850723662203e-08 -0.09978905393413708 +2.2557000000000005 0.7067346213622706 0.7067331637246694 -8.487258624373384e-08 -0.099789117948056 +2.2558000000000002 0.7067347340765338 0.706733277384539 -8.681643998576655e-08 -0.09978918194256971 +2.2559 0.7067348467357271 0.7067333910308187 -8.874962345497422e-08 -0.09978924591768405 +2.256 0.7067349593399816 0.7067335046633988 -9.06716942378899e-08 -0.09978930987340491 +2.2561 0.7067350718894321 0.7067336182821649 -9.258221261767424e-08 -0.09978937380973814 +2.2562 0.7067351843842185 0.706733731886998 -9.4480741668658e-08 -0.0997894377266896 +2.2563 0.7067352968244853 0.7067338454777742 -9.636684736823165e-08 -0.09978950162426516 +2.2564 0.7067354092103817 0.7067339590543653 -9.824009868184685e-08 -0.09978956550247067 +2.2565 0.7067355215420612 0.7067340726166383 -1.001000676714367e-07 -0.099789629361312 +2.2565999999999997 0.7067356338196823 0.7067341861644558 -1.0194632959256017e-07 -0.09978969320079502 +2.2567000000000004 0.7067357460434076 0.7067342996976755 -1.0377846298027099e-07 -0.09978975702092553 +2.2568 0.7067358582134045 0.7067344132161513 -1.05596049762742e-07 -0.09978982082170947 +2.2569 0.7067359703298446 0.706734526719732 -1.0739867534366454e-07 -0.09978988460315263 +2.257 0.7067360823929041 0.7067346402082622 -1.0918592870112764e-07 -0.09978994836526094 +2.2571 0.7067361944027635 0.7067347536815819 -1.1095740247782371e-07 -0.0997900121080401 +2.2572 0.7067363063596072 0.7067348671395275 -1.1271269308339715e-07 -0.09979007583149607 +2.2573000000000003 0.7067364182636247 0.7067349805819303 -1.1445140076817018e-07 -0.09979013953563468 +2.2574 0.7067365301150093 0.7067350940086179 -1.1617312974630811e-07 -0.09979020322046174 +2.2575 0.7067366419139585 0.7067352074194133 -1.178774882443917e-07 -0.09979026688598318 +2.2576 0.7067367536606739 0.7067353208141358 -1.1956408861937828e-07 -0.09979033053220476 +2.2577000000000003 0.7067368653553612 0.7067354341926001 -1.2123254744013379e-07 -0.09979039415913234 +2.2578 0.7067369769982303 0.706735547554617 -1.2288248557416892e-07 -0.09979045776677174 +2.2579000000000002 0.7067370885894952 0.7067356608999933 -1.2451352826570172e-07 -0.09979052135512881 +2.258 0.7067372001293735 0.7067357742285321 -1.2612530523627152e-07 -0.09979058492420936 +2.2580999999999998 0.7067373116180868 0.7067358875400318 -1.2771745075412788e-07 -0.09979064847401924 +2.2582000000000004 0.7067374230558612 0.7067360008342882 -1.2928960372790566e-07 -0.09979071200456432 +2.2583 0.7067375344429259 0.7067361141110922 -1.308414077794834e-07 -0.09979077551585037 +2.2584 0.7067376457795138 0.706736227370231 -1.323725113393931e-07 -0.09979083900788327 +2.2585 0.706737757065862 0.7067363406114886 -1.3388256769886198e-07 -0.09979090248066878 +2.2586 0.7067378683022111 0.7067364538346451 -1.353712351208347e-07 -0.09979096593421276 +2.2587 0.7067379794888051 0.7067365670394767 -1.3683817689201516e-07 -0.09979102936852098 +2.2588000000000004 0.7067380906258919 0.7067366802257568 -1.38283061413072e-07 -0.09979109278359936 +2.2589 0.7067382017137226 0.7067367933932542 -1.3970556227323183e-07 -0.09979115617945361 +2.259 0.7067383127525517 0.7067369065417354 -1.4110535831619864e-07 -0.0997912195560896 +2.2591 0.7067384237426375 0.7067370196709629 -1.4248213372168583e-07 -0.09979128291351319 +2.2592000000000003 0.7067385346842412 0.7067371327806959 -1.438355780609274e-07 -0.09979134625173014 +2.2593 0.7067386455776272 0.7067372458706902 -1.4516538637647514e-07 -0.09979140957074625 +2.2594000000000003 0.7067387564230636 0.7067373589406987 -1.4647125926720017e-07 -0.09979147287056733 +2.2595 0.706738867220821 0.7067374719904711 -1.477529029247221e-07 -0.09979153615119918 +2.2596 0.7067389779711738 0.7067375850197539 -1.490100292218799e-07 -0.09979159941264763 +2.2597000000000005 0.7067390886743989 0.7067376980282907 -1.502423557699778e-07 -0.09979166265491851 +2.2598000000000003 0.7067391993307761 0.706737811015822 -1.5144960597950063e-07 -0.09979172587801756 +2.2599 0.7067393099405883 0.7067379239820853 -1.5263150912950274e-07 -0.09979178908195058 +2.26 0.7067394205041214 0.7067380369268157 -1.5378780041618023e-07 -0.09979185226672341 +2.2601 0.7067395310216641 0.7067381498497451 -1.5491822102225994e-07 -0.09979191543234187 +2.2602 0.7067396414935072 0.7067382627506028 -1.5602251818465362e-07 -0.09979197857881164 +2.2603 0.7067397519199445 0.7067383756291157 -1.5710044522221356e-07 -0.09979204170613865 +2.2604 0.7067398623012726 0.7067384884850079 -1.5815176161379507e-07 -0.0997921048143286 +2.2605 0.7067399726377903 0.7067386013180005 -1.5917623304335937e-07 -0.0997921679033873 +2.2605999999999997 0.7067400829297992 0.706738714127813 -1.6017363146068886e-07 -0.09979223097332052 +2.2607000000000004 0.7067401931776025 0.7067388269141623 -1.6114373511434688e-07 -0.09979229402413407 +2.2608 0.7067403033815065 0.7067389396767629 -1.6208632862106664e-07 -0.09979235705583372 +2.2609 0.7067404135418194 0.7067390524153271 -1.630012030056499e-07 -0.0997924200684253 +2.261 0.7067405236588518 0.7067391651295647 -1.6388815573219195e-07 -0.09979248306191453 +2.2611 0.7067406337329158 0.7067392778191841 -1.6474699077520527e-07 -0.09979254603630727 +2.2612 0.7067407437643262 0.7067393904838911 -1.655775186525793e-07 -0.09979260899160922 +2.2613000000000003 0.7067408537533993 0.7067395031233898 -1.6637955645680547e-07 -0.0997926719278262 +2.2614 0.7067409637004536 0.706739615737382 -1.6715292789834524e-07 -0.09979273484496398 +2.2615 0.706741073605809 0.7067397283255683 -1.6789746335593714e-07 -0.0997927977430283 +2.2616 0.7067411834697875 0.7067398408876471 -1.686129999112912e-07 -0.09979286062202491 +2.2617000000000003 0.7067412932927125 0.7067399534233153 -1.6929938137164036e-07 -0.09979292348195964 +2.2618 0.7067414030749093 0.7067400659322683 -1.6995645832004747e-07 -0.09979298632283823 +2.2619000000000002 0.7067415128167043 0.7067401784141999 -1.7058408813448722e-07 -0.0997930491446664 +2.262 0.7067416225184258 0.7067402908688023 -1.711821350260101e-07 -0.09979311194744997 +2.2620999999999998 0.7067417321804033 0.7067404032957667 -1.7175047006302846e-07 -0.0997931747311947 +2.2622000000000004 0.7067418418029673 0.7067405156947826 -1.7228897121468467e-07 -0.09979323749590631 +2.2623 0.7067419513864499 0.7067406280655382 -1.727975233456469e-07 -0.0997933002415906 +2.2624 0.7067420609311843 0.7067407404077211 -1.732760182785592e-07 -0.0997933629682533 +2.2625 0.7067421704375048 0.7067408527210176 -1.7372435477669423e-07 -0.09979342567590024 +2.2626 0.7067422799057463 0.7067409650051126 -1.7414243859079082e-07 -0.09979348836453707 +2.2627 0.7067423893362453 0.7067410772596907 -1.7453018249721786e-07 -0.09979355103416965 +2.2628000000000004 0.7067424987293385 0.7067411894844349 -1.7488750628236183e-07 -0.0997936136848036 +2.2629 0.7067426080853636 0.7067413016790278 -1.7521433674783093e-07 -0.09979367631644477 +2.263 0.7067427174046589 0.7067414138431517 -1.7551060776249683e-07 -0.09979373892909882 +2.2631 0.7067428266875636 0.7067415259764875 -1.7577626025208626e-07 -0.09979380152277154 +2.2632000000000003 0.7067429359344174 0.7067416380787165 -1.7601124224428388e-07 -0.09979386409746868 +2.2633 0.7067430451455601 0.7067417501495186 -1.762155088270989e-07 -0.09979392665319596 +2.2634000000000003 0.7067431543213325 0.7067418621885735 -1.7638902219049846e-07 -0.09979398918995913 +2.2635 0.706743263462075 0.7067419741955612 -1.7653175161946866e-07 -0.09979405170776395 +2.2636 0.7067433725681289 0.7067420861701608 -1.7664367352177024e-07 -0.0997941142066161 +2.2637000000000005 0.7067434816398352 0.7067421981120515 -1.7672477139324405e-07 -0.09979417668652138 +2.2638000000000003 0.7067435906775352 0.7067423100209125 -1.767750358490361e-07 -0.0997942391474855 +2.2639 0.7067436996815701 0.7067424218964224 -1.7679446462706694e-07 -0.09979430158951415 +2.264 0.706743808652281 0.7067425337382607 -1.7678306254986786e-07 -0.09979436401261306 +2.2641 0.7067439175900093 0.7067426455461062 -1.7674084155927527e-07 -0.09979442641678798 +2.2642 0.7067440264950955 0.706742757319639 -1.7666782070949183e-07 -0.09979448880204467 +2.2643 0.7067441353678803 0.7067428690585382 -1.7656402612892252e-07 -0.09979455116838881 +2.2644 0.7067442442087037 0.7067429807624845 -1.7642949103405248e-07 -0.09979461351582612 +2.2645 0.7067443530179056 0.7067430924311583 -1.7626425575373306e-07 -0.0997946758443624 +2.2645999999999997 0.7067444617958252 0.7067432040642405 -1.7606836762509848e-07 -0.09979473815400325 +2.2647000000000004 0.7067445705428008 0.7067433156614129 -1.7584188107336307e-07 -0.0997948004447545 +2.2648 0.7067446792591707 0.7067434272223575 -1.7558485755631015e-07 -0.09979486271662176 +2.2649 0.706744787945272 0.7067435387467578 -1.7529736553306696e-07 -0.0997949249696108 +2.265 0.7067448966014408 0.7067436502342972 -1.749794804987992e-07 -0.09979498720372731 +2.2651 0.7067450052280128 0.7067437616846612 -1.7463128491185254e-07 -0.09979504941897707 +2.2652 0.7067451138253222 0.7067438730975351 -1.742528681902833e-07 -0.0997951116153657 +2.2653000000000003 0.7067452223937027 0.7067439844726054 -1.7384432670491945e-07 -0.09979517379289891 +2.2654 0.7067453309334862 0.7067440958095604 -1.7340576372038008e-07 -0.0997952359515824 +2.2655 0.7067454394450041 0.7067442071080894 -1.7293728942630038e-07 -0.09979529809142192 +2.2656 0.7067455479285863 0.7067443183678823 -1.724390208436566e-07 -0.09979536021242316 +2.2657000000000003 0.7067456563845611 0.7067444295886312 -1.7191108183864379e-07 -0.09979542231459182 +2.2658 0.7067457648132557 0.7067445407700288 -1.7135360307757308e-07 -0.09979548439793354 +2.2659000000000002 0.7067458732149955 0.7067446519117699 -1.707667219973813e-07 -0.09979554646245406 +2.266 0.7067459815901047 0.7067447630135508 -1.701505827761407e-07 -0.0997956085081591 +2.2661 0.7067460899389055 0.7067448740750693 -1.69505336282752e-07 -0.09979567053505434 +2.2662000000000004 0.7067461982617187 0.7067449850960246 -1.6883114006306654e-07 -0.09979573254314543 +2.2663 0.7067463065588632 0.7067450960761184 -1.6812815827917105e-07 -0.0997957945324381 +2.2664 0.7067464148306559 0.7067452070150533 -1.673965616833667e-07 -0.09979585650293804 +2.2665 0.7067465230774124 0.7067453179125347 -1.6663652757827052e-07 -0.09979591845465094 +2.2666 0.706746631299445 0.7067454287682695 -1.6584823975263063e-07 -0.09979598038758244 +2.2667 0.7067467394970657 0.7067455395819665 -1.6503188846744843e-07 -0.09979604230173826 +2.2668000000000004 0.7067468476705827 0.7067456503533371 -1.641876703900591e-07 -0.09979610419712406 +2.2669 0.7067469558203032 0.7067457610820946 -1.6331578855943718e-07 -0.09979616607374553 +2.267 0.7067470639465318 0.7067458717679548 -1.6241645232374646e-07 -0.09979622793160835 +2.2671 0.7067471720495704 0.7067459824106352 -1.6148987729523723e-07 -0.09979628977071817 +2.2672000000000003 0.7067472801297187 0.7067460930098565 -1.6053628531034758e-07 -0.09979635159108069 +2.2673 0.7067473881872742 0.7067462035653411 -1.5955590435337563e-07 -0.09979641339270157 +2.2674000000000003 0.7067474962225317 0.7067463140768147 -1.585489685287239e-07 -0.09979647517558647 +2.2675 0.7067476042357836 0.7067464245440048 -1.5751571797763264e-07 -0.09979653693974111 +2.2676 0.7067477122273192 0.7067465349666422 -1.5645639885389362e-07 -0.09979659868517109 +2.2677000000000005 0.7067478201974253 0.7067466453444601 -1.5537126322150152e-07 -0.09979666041188211 +2.2678000000000003 0.706747928146386 0.7067467556771945 -1.5426056904424557e-07 -0.09979672211987983 +2.2679 0.7067480360744824 0.7067468659645842 -1.5312458009203445e-07 -0.09979678380916994 +2.268 0.7067481439819931 0.706746976206371 -1.5196356587497684e-07 -0.09979684547975803 +2.2681 0.7067482518691932 0.7067470864022997 -1.507778016000133e-07 -0.09979690713164985 +2.2682 0.7067483597363551 0.7067471965521177 -1.495675681032621e-07 -0.09979696876485095 +2.2683 0.7067484675837479 0.7067473066555763 -1.4833315177022188e-07 -0.09979703037936706 +2.2684 0.7067485754116375 0.7067474167124292 -1.470748444698522e-07 -0.09979709197520381 +2.2685 0.7067486832202869 0.7067475267224336 -1.4579294349732763e-07 -0.09979715355236685 +2.2685999999999997 0.7067487910099559 0.7067476366853498 -1.4448775149597526e-07 -0.09979721511086181 +2.2687000000000004 0.7067488987809007 0.7067477466009418 -1.4315957639135513e-07 -0.09979727665069438 +2.2688 0.7067490065333742 0.7067478564689764 -1.4180873130278937e-07 -0.0997973381718702 +2.2689 0.7067491142676257 0.7067479662892244 -1.404355344913205e-07 -0.0997973996743949 +2.269 0.7067492219839014 0.7067480760614596 -1.390403092660364e-07 -0.09979746115827412 +2.2691 0.7067493296824436 0.7067481857854596 -1.376233839216201e-07 -0.09979752262351352 +2.2692 0.7067494373634915 0.7067482954610055 -1.3618509166722637e-07 -0.09979758407011874 +2.2693000000000003 0.7067495450272798 0.706748405087882 -1.3472577052413282e-07 -0.09979764549809535 +2.2694 0.7067496526740407 0.7067485146658774 -1.3324576325635107e-07 -0.09979770690744909 +2.2695 0.7067497603040012 0.7067486241947842 -1.3174541729950306e-07 -0.09979776829818551 +2.2696 0.7067498679173858 0.7067487336743983 -1.302250846740849e-07 -0.09979782967031028 +2.2697000000000003 0.7067499755144147 0.7067488431045192 -1.286851218987306e-07 -0.09979789102382905 +2.2698 0.706750083095304 0.7067489524849508 -1.2712588991041496e-07 -0.09979795235874744 +2.2699000000000003 0.706750190660266 0.7067490618155007 -1.2554775398118667e-07 -0.09979801367507106 +2.27 0.7067502982095095 0.7067491710959801 -1.239510836349017e-07 -0.09979807497280552 +2.2701 0.7067504057432383 0.7067492803262051 -1.2233625254834402e-07 -0.09979813625195649 +2.2702000000000004 0.706750513261653 0.7067493895059951 -1.20703638473163e-07 -0.09979819751252955 +2.2703 0.7067506207649494 0.7067494986351739 -1.1905362315087209e-07 -0.09979825875453034 +2.2704 0.70675072825332 0.7067496077135693 -1.1738659221223469e-07 -0.09979831997796451 +2.2705 0.7067508357269524 0.7067497167410133 -1.1570293510267116e-07 -0.09979838118283763 +2.2706 0.7067509431860304 0.7067498257173424 -1.140030449799101e-07 -0.09979844236915533 +2.2707 0.706751050630733 0.7067499346423969 -1.1228731862378272e-07 -0.09979850353692322 +2.2708000000000004 0.7067511580612355 0.7067500435160217 -1.1055615634428251e-07 -0.0997985646861469 +2.2709 0.7067512654777084 0.7067501523380662 -1.0880996189482905e-07 -0.09979862581683202 +2.271 0.7067513728803181 0.7067502611083839 -1.0704914236558255e-07 -0.09979868692898418 +2.2711 0.7067514802692265 0.7067503698268328 -1.0527410810364651e-07 -0.09979874802260896 +2.2712000000000003 0.7067515876445908 0.7067504784932751 -1.0348527259684132e-07 -0.09979880909771195 +2.2713 0.7067516950065642 0.7067505871075778 -1.0168305239824371e-07 -0.0997988701542988 +2.2714000000000003 0.706751802355295 0.7067506956696123 -9.986786701863398e-08 -0.09979893119237505 +2.2715 0.7067519096909272 0.7067508041792547 -9.804013883368823e-08 -0.09979899221194637 +2.2716 0.7067520170136001 0.7067509126363853 -9.620029298249705e-08 -0.09979905321301834 +2.2717 0.7067521243234485 0.7067510210408895 -9.434875726955366e-08 -0.09979911419559653 +2.2718000000000003 0.7067522316206023 0.7067511293926567 -9.248596205980314e-08 -0.09979917515968657 +2.2719 0.7067523389051873 0.7067512376915817 -9.06123401901715e-08 -0.09979923610529406 +2.272 0.706752446177324 0.706751345937563 -8.872832685941079e-08 -0.09979929703242457 +2.2721 0.7067525534371285 0.7067514541305046 -8.683435953355662e-08 -0.0997993579410837 +2.2722 0.7067526606847122 0.706751562270315 -8.493087783837533e-08 -0.09979941883127703 +2.2723 0.7067527679201816 0.7067516703569073 -8.301832346221949e-08 -0.09979947970301016 +2.2724 0.7067528751436385 0.7067517783901998 -8.109714005020974e-08 -0.09979954055628865 +2.2725 0.7067529823551799 0.7067518863701149 -7.916777310101875e-08 -0.0997996013911181 +2.2725999999999997 0.7067530895548981 0.7067519942965801 -7.723066987319616e-08 -0.09979966220750408 +2.2727000000000004 0.7067531967428806 0.7067521021695279 -7.528627926634002e-08 -0.09979972300545219 +2.2728 0.7067533039192098 0.7067522099888957 -7.333505172698804e-08 -0.09979978378496801 +2.2729 0.7067534110839634 0.7067523177546253 -7.137743914019737e-08 -0.0997998445460571 +2.273 0.7067535182372143 0.7067524254666638 -6.941389472936432e-08 -0.09979990528872504 +2.2731 0.7067536253790303 0.7067525331249631 -6.744487294650311e-08 -0.09979996601297743 +2.2732 0.7067537325094745 0.7067526407294795 -6.547082937293294e-08 -0.09980002671881978 +2.2733000000000003 0.706753839628605 0.7067527482801752 -6.349222060391888e-08 -0.09980008740625773 +2.2734 0.706753946736475 0.7067528557770164 -6.150950415629783e-08 -0.0998001480752968 +2.2735 0.7067540538331327 0.7067529632199744 -5.9523138349216326e-08 -0.09980020872594257 +2.2736 0.7067541609186216 0.7067530706090257 -5.753358220872071e-08 -0.0998002693582006 +2.2737000000000003 0.7067542679929801 0.7067531779441516 -5.554129535803587e-08 -0.09980032997207647 +2.2738 0.7067543750562417 0.7067532852253386 -5.354673790871137e-08 -0.09980039056757578 +2.2739000000000003 0.7067544821084348 0.7067533924525775 -5.155037035957377e-08 -0.099800451144704 +2.274 0.7067545891495832 0.7067534996258646 -4.9552653485162267e-08 -0.09980051170346678 +2.2741 0.7067546961797053 0.7067536067452009 -4.7554048234572585e-08 -0.09980057224386961 +2.2742000000000004 0.7067548031988147 0.7067537138105924 -4.555501562097681e-08 -0.09980063276591805 +2.2743 0.7067549102069204 0.7067538208220501 -4.355601661748575e-08 -0.09980069326961771 +2.2744 0.706755017204026 0.7067539277795898 -4.155751204985359e-08 -0.09980075375497408 +2.2745 0.7067551241901301 0.7067540346832324 -3.955996249208277e-08 -0.0998008142219927 +2.2746 0.7067552311652266 0.7067541415330039 -3.756382815727193e-08 -0.09980087467067913 +2.2747 0.7067553381293048 0.7067542483289344 -3.5569568794372765e-08 -0.09980093510103895 +2.2748000000000004 0.7067554450823484 0.7067543550710604 -3.3577643582900427e-08 -0.0998009955130777 +2.2749 0.7067555520243366 0.7067544617594219 -3.1588511021979e-08 -0.09980105590680088 +2.275 0.7067556589552435 0.7067545683940647 -2.9602628831299632e-08 -0.09980111628221411 +2.2751 0.7067557658750383 0.7067546749750389 -2.762045384248346e-08 -0.09980117663932286 +2.2752000000000003 0.7067558727836853 0.7067547815023999 -2.5642441895106644e-08 -0.09980123697813266 +2.2753 0.7067559796811442 0.706754887976208 -2.3669047730448534e-08 -0.09980129729864914 +2.2754000000000003 0.7067560865673697 0.706754994396528 -2.1700724887625117e-08 -0.09980135760087777 +2.2755 0.706756193442311 0.70675510076343 -1.9737925602975048e-08 -0.0998014178848241 +2.2756 0.7067563003059133 0.7067552070769885 -1.7781100697736307e-08 -0.09980147815049366 +2.2757 0.7067564071581166 0.7067553133372828 -1.583069948350377e-08 -0.09980153839789191 +2.2758000000000003 0.7067565139988563 0.7067554195443975 -1.3887169656411069e-08 -0.09980159862702445 +2.2759 0.7067566208280627 0.7067555256984218 -1.1950957189577754e-08 -0.0998016588378968 +2.276 0.7067567276456617 0.7067556317994496 -1.0022506237265805e-08 -0.09980171903051452 +2.2761 0.7067568344515742 0.7067557378475792 -8.102259030362546e-09 -0.09980177920488309 +2.2762000000000002 0.7067569412457164 0.706755843842914 -6.190655773598286e-09 -0.09980183936100803 +2.2763 0.7067570480279999 0.7067559497855626 -4.288134549702838e-09 -0.0998018994988949 +2.2764 0.7067571547983316 0.7067560556756369 -2.3951312079495413e-09 -0.09980195961854917 +2.2765 0.7067572615566133 0.7067561615132545 -5.120792826232567e-10 -0.09980201971997636 +2.2765999999999997 0.706757368302743 0.7067562672985375 1.3605901266755538e-09 -0.09980207980318201 +2.2767000000000004 0.7067574750366132 0.7067563730316124 3.222448437430192e-09 -0.0998021398681716 +2.2768 0.7067575817581129 0.7067564787126103 5.073069691760579e-09 -0.09980219991495067 +2.2769 0.7067576884671255 0.7067565843416668 6.912030654435131e-09 -0.0998022599435247 +2.277 0.7067577951635304 0.7067566899189223 8.738910900474295e-09 -0.09980231995389921 +2.2771 0.7067579018472028 0.7067567954445213 1.0553292918366597e-08 -0.09980237994607975 +2.2772 0.7067580085180125 0.706756900918613 1.2354762202876346e-08 -0.0998024399200718 +2.2773000000000003 0.7067581151758261 0.7067570063413509 1.4142907353055512e-08 -0.09980249987588084 +2.2774 0.7067582218205051 0.7067571117128926 1.5917320164184068e-08 -0.09980255981351241 +2.2775 0.7067583284519062 0.7067572170334007 1.76775957205777e-08 -0.09980261973297196 +2.2776 0.706758435069883 0.7067573223030414 1.9423332484058697e-08 -0.09980267963426503 +2.2777000000000003 0.7067585416742839 0.7067574275219859 2.1154132390233116e-08 -0.09980273951739711 +2.2778 0.7067586482649533 0.7067575326904089 2.2869600942165835e-08 -0.0998027993823737 +2.2779000000000003 0.7067587548417316 0.7067576378084895 2.4569347289310484e-08 -0.09980285922920025 +2.278 0.7067588614044547 0.7067577428764115 2.6252984331592844e-08 -0.09980291905788229 +2.2781 0.7067589679529547 0.7067578478943621 2.7920128795738686e-08 -0.0998029788684253 +2.2782000000000004 0.7067590744870595 0.7067579528625328 2.9570401327214113e-08 -0.0998030386608348 +2.2783 0.7067591810065934 0.706758057781119 3.120342657349229e-08 -0.09980309843511624 +2.2784 0.7067592875113757 0.7067581626503205 3.281883327425905e-08 -0.09980315819127511 +2.2785 0.7067593940012228 0.7067582674703405 3.441625433774076e-08 -0.09980321792931687 +2.2786 0.7067595004759464 0.7067583722413867 3.599532693611407e-08 -0.09980327764924705 +2.2787 0.7067596069353551 0.7067584769636699 3.7555692580099054e-08 -0.09980333735107114 +2.2788000000000004 0.7067597133792533 0.7067585816374051 3.909699719875648e-08 -0.09980339703479454 +2.2789 0.7067598198074415 0.7067586862628112 4.0618891226223974e-08 -0.09980345670042283 +2.279 0.7067599262197168 0.7067587908401107 4.2121029667635534e-08 -0.0998035163479614 +2.2791 0.7067600326158724 0.7067588953695293 4.360307219279658e-08 -0.09980357597741574 +2.2792000000000003 0.7067601389956983 0.7067589998512969 4.506468321251178e-08 -0.09980363558879136 +2.2793 0.7067602453589805 0.7067591042856467 4.650553194103513e-08 -0.09980369518209373 +2.2794 0.7067603517055017 0.706759208672815 4.792529247760191e-08 -0.09980375475732824 +2.2795 0.7067604580350413 0.7067593130130425 4.932364388796073e-08 -0.09980381431450047 +2.2796 0.7067605643473751 0.7067594173065723 5.070027026855828e-08 -0.09980387385361583 +2.2797 0.7067606706422758 0.7067595215536514 5.2054860814193527e-08 -0.0998039333746798 +2.2798000000000003 0.7067607769195123 0.7067596257545297 5.33871099030192e-08 -0.09980399287769781 +2.2799 0.7067608831788509 0.7067597299094605 5.4696717148583485e-08 -0.0998040523626753 +2.28 0.7067609894200542 0.7067598340187004 5.5983387472688384e-08 -0.09980411182961778 +2.2801 0.7067610956428825 0.7067599380825089 5.7246831181717583e-08 -0.09980417127853071 +2.2802000000000002 0.7067612018470919 0.7067600421011486 5.848676402388231e-08 -0.0998042307094195 +2.2803 0.7067613080324369 0.7067601460748851 5.970290724299776e-08 -0.09980429012228968 +2.2804 0.7067614141986676 0.7067602500039869 6.089498766868873e-08 -0.09980434951714662 +2.2805 0.7067615203455322 0.7067603538887253 6.206273774241045e-08 -0.0998044088939958 +2.2805999999999997 0.7067616264727759 0.7067604577293742 6.320589561112366e-08 -0.09980446825284266 +2.2807000000000004 0.706761732580141 0.7067605615262111 6.432420516025439e-08 -0.09980452759369267 +2.2808 0.7067618386673675 0.7067606652795152 6.541741607787865e-08 -0.0998045869165513 +2.2809 0.7067619447341924 0.7067607689895685 6.648528392584618e-08 -0.09980464622142393 +2.281 0.7067620507803501 0.7067608726566563 6.752757016927069e-08 -0.09980470550831605 +2.2811 0.7067621568055729 0.7067609762810653 6.85440422528577e-08 -0.0998047647772331 +2.2812 0.70676226280959 0.706761079863085 6.953447363733378e-08 -0.09980482402818046 +2.2813000000000003 0.7067623687921287 0.7067611834030079 7.049864385148819e-08 -0.09980488326116357 +2.2814 0.7067624747529144 0.7067612869011282 7.143633855288822e-08 -0.09980494247618793 +2.2815 0.7067625806916698 0.7067613903577421 7.234734957124733e-08 -0.099805001673259 +2.2816 0.7067626866081154 0.7067614937731486 7.323147493444593e-08 -0.09980506085238215 +2.2817000000000003 0.7067627925019695 0.7067615971476483 7.408851895179813e-08 -0.09980512001356283 +2.2818 0.7067628983729488 0.706761700481544 7.491829221058233e-08 -0.09980517915680648 +2.2819000000000003 0.7067630042207675 0.7067618037751402 7.572061165930788e-08 -0.09980523828211846 +2.282 0.7067631100451386 0.7067619070287436 7.649530063200127e-08 -0.09980529738950426 +2.2821 0.7067632158457728 0.7067620102426628 7.724218886902279e-08 -0.09980535647896932 +2.2822000000000005 0.7067633216223791 0.706762113417208 7.796111258819016e-08 -0.09980541555051903 +2.2823 0.7067634273746648 0.7067622165526908 7.865191449171749e-08 -0.09980547460415884 +2.2824 0.7067635331023359 0.7067623196494248 7.931444382519581e-08 -0.09980553363989414 +2.2825 0.7067636388050962 0.7067624227077247 7.994855637412368e-08 -0.09980559265773031 +2.2826 0.7067637444826489 0.7067625257279071 8.05541145489086e-08 -0.09980565165767286 +2.2827 0.7067638501346949 0.70676262871029 8.113098736578506e-08 -0.09980571063972714 +2.2828000000000004 0.7067639557609344 0.7067627316551924 8.167905050406044e-08 -0.09980576960389856 +2.2829 0.7067640613610664 0.7067628345629346 8.219818631999276e-08 -0.09980582855019254 +2.283 0.7067641669347882 0.7067629374338384 8.268828385372962e-08 -0.09980588747861448 +2.2831 0.7067642724817962 0.7067630402682266 8.314923890390125e-08 -0.09980594638916983 +2.2832000000000003 0.7067643780017862 0.7067631430664225 8.35809540015997e-08 -0.09980600528186398 +2.2833 0.7067644834944525 0.7067632458287509 8.398333845201222e-08 -0.09980606415670235 +2.2834 0.7067645889594887 0.7067633485555377 8.435630835350316e-08 -0.0998061230136903 +2.2835 0.7067646943965875 0.7067634512471088 8.469978659761401e-08 -0.09980618185283326 +2.2836 0.7067647998054408 0.7067635539037915 8.501370291069676e-08 -0.09980624067413657 +2.2837 0.7067649051857402 0.7067636565259139 8.529799385911807e-08 -0.09980629947760573 +2.2838000000000003 0.7067650105371762 0.706763759113804 8.555260284058563e-08 -0.09980635826324609 +2.2839 0.7067651158594392 0.7067638616677905 8.577748013445519e-08 -0.09980641703106302 +2.284 0.7067652211522191 0.7067639641882033 8.597258287570964e-08 -0.09980647578106196 +2.2841 0.706765326415205 0.7067640666753716 8.613787508444937e-08 -0.09980653451324827 +2.2842000000000002 0.7067654316480859 0.706764169129626 8.627332765374918e-08 -0.09980659322762736 +2.2843 0.7067655368505508 0.7067642715512967 8.63789183739444e-08 -0.09980665192420463 +2.2844 0.7067656420222885 0.7067643739407135 8.645463192222258e-08 -0.09980671060298543 +2.2845 0.7067657471629875 0.7067644762982073 8.650045986262345e-08 -0.09980676926397516 +2.2845999999999997 0.7067658522723362 0.7067645786241081 8.6516400658182e-08 -0.09980682790717917 +2.2847000000000004 0.7067659573500237 0.7067646809187469 8.650245965705072e-08 -0.09980688653260288 +2.2848 0.7067660623957386 0.7067647831824536 8.645864911331624e-08 -0.0998069451402517 +2.2849 0.7067661674091698 0.7067648854155583 8.638498814363127e-08 -0.09980700373013093 +2.285 0.7067662723900066 0.7067649876183908 8.628150275497015e-08 -0.09980706230224601 +2.2851 0.7067663773379388 0.7067650897912803 8.614822580646497e-08 -0.09980712085660227 +2.2852 0.7067664822526567 0.7067651919345559 8.598519702675278e-08 -0.09980717939320513 +2.2853000000000003 0.7067665871338507 0.7067652940485458 8.579246299142418e-08 -0.09980723791205993 +2.2854 0.7067666919812119 0.7067653961335781 8.557007709700248e-08 -0.09980729641317206 +2.2855 0.7067667967944323 0.7067654981899801 8.53180995748215e-08 -0.09980735489654691 +2.2856 0.7067669015732045 0.7067656002180778 8.503659744592273e-08 -0.09980741336218979 +2.2857000000000003 0.7067670063172218 0.7067657022181972 8.472564453493314e-08 -0.09980747181010612 +2.2858 0.7067671110261786 0.7067658041906627 8.438532143190125e-08 -0.09980753024030124 +2.2859000000000003 0.7067672156997699 0.7067659061357983 8.401571545760267e-08 -0.09980758865278049 +2.286 0.7067673203376921 0.7067660080539266 8.361692067221371e-08 -0.09980764704754928 +2.2861 0.7067674249396423 0.7067661099453696 8.318903782847387e-08 -0.09980770542461292 +2.2862000000000005 0.7067675295053191 0.7067662118104475 8.273217436474689e-08 -0.09980776378397681 +2.2863 0.7067676340344222 0.70676631364948 8.224644435471384e-08 -0.09980782212564632 +2.2864 0.7067677385266529 0.7067664154627844 8.173196850563835e-08 -0.09980788044962674 +2.2865 0.706767842981713 0.7067665172506779 8.118887409938602e-08 -0.09980793875592345 +2.2866 0.7067679473993067 0.7067666190134749 8.061729498722026e-08 -0.0998079970445418 +2.2867 0.7067680517791394 0.7067667207514898 8.001737154643418e-08 -0.09980805531548716 +2.2868000000000004 0.7067681561209179 0.7067668224650343 7.938925065432978e-08 -0.0998081135687649 +2.2869 0.7067682604243507 0.7067669241544188 7.873308563791093e-08 -0.0998081718043803 +2.287 0.7067683646891483 0.7067670258199517 7.804903623745418e-08 -0.09980823002233874 +2.2870999999999997 0.7067684689150227 0.7067671274619398 7.733726858742684e-08 -0.09980828822264556 +2.2872000000000003 0.7067685731016877 0.7067672290806882 7.659795514536327e-08 -0.09980834640530606 +2.2873 0.7067686772488595 0.7067673306765001 7.583127467278294e-08 -0.09980840457032568 +2.2874 0.7067687813562558 0.7067674322496763 7.503741218835291e-08 -0.09980846271770963 +2.2875 0.7067688854235963 0.7067675338005159 7.421655891758083e-08 -0.09980852084746333 +2.2876 0.7067689894506035 0.7067676353293157 7.336891225812048e-08 -0.09980857895959211 +2.2877 0.7067690934370017 0.7067677368363705 7.249467572773005e-08 -0.09980863705410131 +2.2878000000000003 0.7067691973825171 0.7067678383219723 7.159405890008741e-08 -0.09980869513099627 +2.2879 0.7067693012868788 0.7067679397864113 7.066727738744283e-08 -0.09980875319028226 +2.288 0.7067694051498177 0.7067680412299753 6.971455274173977e-08 -0.09980881123196467 +2.2881 0.7067695089710678 0.7067681426529493 6.873611245634959e-08 -0.09980886925604882 +2.2882000000000002 0.7067696127503653 0.7067682440556162 6.773218986198815e-08 -0.09980892726254004 +2.2883 0.7067697164874486 0.706768345438256 6.67030240972255e-08 -0.09980898525144358 +2.2884 0.7067698201820592 0.7067684468011457 6.564886006511783e-08 -0.09980904322276479 +2.2885 0.7067699238339415 0.7067685481445606 6.456994833953233e-08 -0.09980910117650904 +2.2885999999999997 0.706770027442842 0.7067686494687726 6.34665451373917e-08 -0.09980915911268161 +2.2887000000000004 0.7067701310085106 0.7067687507740508 6.233891224234622e-08 -0.09980921703128784 +2.2888 0.7067702345306999 0.7067688520606614 6.118731693711965e-08 -0.09980927493233305 +2.2889 0.7067703380091652 0.7067689533288679 6.001203195320215e-08 -0.09980933281582255 +2.289 0.7067704414436653 0.7067690545789307 5.8813335396257216e-08 -0.09980939068176164 +2.2891 0.7067705448339612 0.7067691558111067 5.759151068714108e-08 -0.09980944853015561 +2.2892 0.7067706481798178 0.7067692570256504 5.634684649424848e-08 -0.09980950636100983 +2.2893000000000003 0.7067707514810031 0.706769358222813 5.507963667626681e-08 -0.09980956417432957 +2.2894 0.7067708547372877 0.7067694594028417 5.3790180185031566e-08 -0.09980962197012011 +2.2895 0.7067709579484462 0.7067695605659814 5.247878101868886e-08 -0.09980967974838681 +2.2896 0.706771061114256 0.7067696617124736 5.1145748136693925e-08 -0.09980973750913497 +2.2897000000000003 0.7067711642344984 0.7067697628425555 4.9791395397361105e-08 -0.09980979525236988 +2.2898 0.7067712673089576 0.7067698639564619 4.841604147286238e-08 -0.09980985297809684 +2.2899000000000003 0.7067713703374214 0.7067699650544232 4.7020009790246786e-08 -0.09980991068632113 +2.29 0.7067714733196814 0.7067700661366672 4.560362844643895e-08 -0.09980996837704806 +2.2901 0.7067715762555321 0.7067701672034172 4.41672301197682e-08 -0.09981002605028283 +2.2902000000000005 0.7067716791447727 0.706770268254894 4.271115200925324e-08 -0.0998100837060309 +2.2903000000000002 0.7067717819872051 0.7067703692913134 4.1235735756539604e-08 -0.09981014134429744 +2.2904 0.7067718847826356 0.7067704703128885 3.9741327347020405e-08 -0.09981019896508783 +2.2905 0.706771987530874 0.7067705713198283 3.822827704565157e-08 -0.09981025656840731 +2.2906 0.7067720902317335 0.7067706723123379 3.669693930154205e-08 -0.09981031415426116 +2.2907 0.7067721928850318 0.7067707732906183 3.514767268376906e-08 -0.09981037172265467 +2.2908000000000004 0.7067722954905901 0.7067708742548673 3.358083978423354e-08 -0.09981042927359311 +2.2909 0.7067723980482339 0.7067709752052782 3.199680713092401e-08 -0.09981048680708182 +2.291 0.7067725005577923 0.7067710761420404 3.039594510811927e-08 -0.09981054432312605 +2.2910999999999997 0.7067726030190984 0.7067711770653394 2.8778627876591134e-08 -0.0998106018217311 +2.2912000000000003 0.70677270543199 0.7067712779753564 2.714523326084739e-08 -0.09981065930290219 +2.2913 0.7067728077963082 0.7067713788722688 2.5496142690151213e-08 -0.09981071676664464 +2.2914 0.7067729101118985 0.7067714797562498 2.3831741089233582e-08 -0.0998107742129637 +2.2915 0.7067730123786108 0.7067715806274679 2.2152416807169617e-08 -0.09981083164186465 +2.2916 0.706773114596299 0.7067716814860883 2.0458561514162532e-08 -0.09981088905335274 +2.2917 0.7067732167648215 0.7067717823322714 1.8750570101797037e-08 -0.09981094644743332 +2.2918000000000003 0.7067733188840404 0.7067718831661733 1.7028840612783036e-08 -0.0998110038241116 +2.2919 0.7067734209538226 0.7067719839879456 1.5293774131668048e-08 -0.0998110611833928 +2.292 0.7067735229740395 0.7067720847977363 1.3545774698101032e-08 -0.0998111185252823 +2.2921 0.7067736249445662 0.7067721855956883 1.1785249204483705e-08 -0.09981117584978524 +2.2922000000000002 0.7067737268652827 0.7067722863819403 1.0012607317907984e-08 -0.09981123315690693 +2.2923 0.7067738287360736 0.7067723871566267 8.22826137260313e-09 -0.09981129044665268 +2.2924 0.7067739305568275 0.7067724879198773 6.432626277995401e-09 -0.09981134771902771 +2.2925 0.7067740323274377 0.7067725886718175 4.626119418094099e-09 -0.09981140497403729 +2.2925999999999997 0.7067741340478019 0.7067726894125683 2.809160558683854e-09 -0.09981146221168663 +2.2927000000000004 0.7067742357178223 0.706772790142246 9.821717432412225e-10 -0.09981151943198106 +2.2928 0.7067743373374058 0.7067728908609621 -8.544227955362138e-10 -0.09981157663492575 +2.2929 0.7067744389064641 0.7067729915688237 -2.7001967363438073e-09 -0.09981163382052599 +2.293 0.7067745404249131 0.7067730922659337 -4.554721769883807e-09 -0.09981169098878706 +2.2931 0.7067746418926732 0.7067731929523897 -6.417567701214044e-09 -0.09981174813971416 +2.2932 0.70677474330967 0.7067732936282851 -8.288302550361892e-09 -0.09981180527331254 +2.2933000000000003 0.7067748446758335 0.7067733942937087 -1.0166492640795166e-08 -0.09981186238958747 +2.2934 0.7067749459910981 0.7067734949487443 -1.205170271434755e-08 -0.09981191948854418 +2.2935 0.7067750472554032 0.7067735955934709 -1.3943496026628394e-08 -0.09981197657018788 +2.2936 0.706775148468693 0.7067736962279634 -1.5841434443733537e-08 -0.09981203363452387 +2.2937000000000003 0.7067752496309159 0.7067737968522916 -1.774507854719609e-08 -0.09981209068155733 +2.2938 0.7067753507420256 0.7067738974665201 -1.9653987737202477e-08 -0.09981214771129351 +2.2939000000000003 0.7067754518019803 0.7067739980707098 -2.1567720331471668e-08 -0.0998122047237377 +2.294 0.7067755528107431 0.7067740986649161 -2.3485833672374362e-08 -0.0998122617188951 +2.2941 0.7067756537682814 0.7067741992491898 -2.5407884223643817e-08 -0.09981231869677093 +2.2942000000000005 0.7067757546745679 0.7067742998235769 -2.733342767532662e-08 -0.09981237565737039 +2.2943000000000002 0.7067758555295797 0.7067744003881187 -2.926201904699874e-08 -0.09981243260069877 +2.2944 0.7067759563332989 0.7067745009428515 -3.119321278881315e-08 -0.09981248952676125 +2.2945 0.7067760570857127 0.7067746014878074 -3.312656288601695e-08 -0.0998125464355631 +2.2946 0.7067761577868121 0.7067747020230126 -3.5061622961083186e-08 -0.09981260332710946 +2.2947 0.706776258436594 0.7067748025484897 -3.699794637898688e-08 -0.09981266020140567 +2.2948000000000004 0.7067763590350593 0.7067749030642557 -3.8935086345433766e-08 -0.09981271705845682 +2.2949 0.7067764595822144 0.7067750035703233 -4.087259601457576e-08 -0.09981277389826826 +2.295 0.7067765600780699 0.7067751040667001 -4.281002858913703e-08 -0.09981283072084512 +2.2950999999999997 0.7067766605226413 0.7067752045533887 -4.4746937424551634e-08 -0.09981288752619263 +2.2952000000000004 0.7067767609159494 0.7067753050303877 -4.668287613255901e-08 -0.09981294431431609 +2.2953 0.7067768612580191 0.7067754054976898 -4.861739868284795e-08 -0.09981300108522062 +2.2954 0.7067769615488803 0.7067755059552837 -5.055005950676053e-08 -0.0998130578389114 +2.2955 0.7067770617885678 0.7067756064031532 -5.2480413599695006e-08 -0.09981311457539371 +2.2956 0.7067771619771211 0.7067757068412774 -5.440801662155714e-08 -0.09981317129467278 +2.2957 0.7067772621145845 0.7067758072696301 -5.6332425002903613e-08 -0.0998132279967537 +2.2958000000000003 0.706777362201007 0.706775907688181 -5.825319604252019e-08 -0.09981328468164179 +2.2959 0.7067774622364423 0.7067760080968946 -6.016988801302303e-08 -0.09981334134934222 +2.296 0.7067775622209489 0.7067761084957309 -6.20820602595211e-08 -0.09981339799986017 +2.2961 0.7067776621545901 0.7067762088846452 -6.398927330326584e-08 -0.09981345463320083 +2.2962000000000002 0.7067777620374337 0.7067763092635881 -6.589108893966314e-08 -0.09981351124936948 +2.2963 0.7067778618695524 0.7067764096325053 -6.778707034322401e-08 -0.09981356784837124 +2.2964 0.7067779616510232 0.706776509991338 -6.967678216427547e-08 -0.09981362443021136 +2.2965 0.7067780613819283 0.7067766103400227 -7.155979063087556e-08 -0.09981368099489497 +2.2965999999999998 0.706778161062354 0.7067767106784912 -7.34356636459578e-08 -0.0998137375424273 +2.2967000000000004 0.7067782606923916 0.7067768110066706 -7.530397088751153e-08 -0.09981379407281352 +2.2968 0.7067783602721367 0.7067769113244836 -7.716428391309899e-08 -0.09981385058605882 +2.2969 0.7067784598016897 0.7067770116318487 -7.901617624268831e-08 -0.09981390708216846 +2.297 0.7067785592811556 0.7067771119286789 -8.085922347748215e-08 -0.09981396356114754 +2.2971 0.7067786587106436 0.7067772122148831 -8.269300337971491e-08 -0.09981402002300124 +2.2972 0.7067787580902678 0.7067773124903661 -8.451709597283308e-08 -0.09981407646773481 +2.2973000000000003 0.7067788574201462 0.7067774127550277 -8.633108364818065e-08 -0.09981413289535336 +2.2974 0.7067789567004021 0.7067775130087635 -8.813455124653119e-08 -0.09981418930586215 +2.2975 0.7067790559311624 0.7067776132514645 -8.992708616650802e-08 -0.09981424569926628 +2.2976 0.7067791551125591 0.7067777134830173 -9.170827844264678e-08 -0.09981430207557099 +2.2977000000000003 0.706779254244728 0.7067778137033045 -9.347772085468303e-08 -0.09981435843478143 +2.2978 0.7067793533278093 0.7067779139122039 -9.523500900734949e-08 -0.09981441477690274 +2.2979000000000003 0.7067794523619478 0.7067780141095892 -9.697974143879629e-08 -0.09981447110194012 +2.298 0.7067795513472928 0.7067781142953298 -9.871151969952086e-08 -0.09981452740989881 +2.2981 0.7067796502839969 0.7067782144692907 -1.004299484512472e-07 -0.09981458370078389 +2.2982000000000005 0.7067797491722174 0.7067783146313329 -1.0213463554065161e-07 -0.09981463997460048 +2.2983000000000002 0.7067798480121166 0.7067784147813133 -1.0382519211125235e-07 -0.09981469623135389 +2.2984 0.7067799468038594 0.7067785149190844 -1.0550123267453332e-07 -0.09981475247104914 +2.2985 0.7067800455476158 0.7067786150444948 -1.0716237521229272e-07 -0.0998148086936915 +2.2986 0.7067801442435597 0.706778715157389 -1.0880824125123617e-07 -0.0998148648992861 +2.2987 0.7067802428918689 0.7067788152576071 -1.104384559635907e-07 -0.09981492108783807 +2.2988000000000004 0.7067803414927254 0.7067789153449862 -1.1205264823128946e-07 -0.09981497725935264 +2.2989 0.7067804400463147 0.7067790154193582 -1.1365045073964686e-07 -0.09981503341383491 +2.299 0.7067805385528261 0.7067791154805521 -1.1523150007103355e-07 -0.09981508955129 +2.2990999999999997 0.7067806370124539 0.7067792155283925 -1.1679543678901061e-07 -0.09981514567172314 +2.2992000000000004 0.7067807354253948 0.7067793155627005 -1.1834190550598367e-07 -0.09981520177513946 +2.2993 0.70678083379185 0.7067794155832929 -1.1987055495779608e-07 -0.09981525786154405 +2.2994 0.7067809321120242 0.7067795155899836 -1.213810380991387e-07 -0.09981531393094215 +2.2995 0.7067810303861257 0.7067796155825825 -1.2287301217293878e-07 -0.09981536998333883 +2.2996 0.706781128614367 0.7067797155608951 -1.2434613881444345e-07 -0.09981542601873927 +2.2997 0.7067812267969635 0.7067798155247247 -1.2580008408417942e-07 -0.09981548203714861 +2.2998000000000003 0.7067813249341346 0.7067799154738699 -1.272345185737711e-07 -0.09981553803857203 +2.2999 0.7067814230261027 0.7067800154081265 -1.2864911747186014e-07 -0.09981559402301464 +2.3 0.7067815210730937 0.7067801153272867 -1.3004356064216793e-07 -0.09981564999048158 +2.3001 0.7067816190753373 0.7067802152311389 -1.3141753268074152e-07 -0.09981570594097795 +2.3002000000000002 0.7067817170330661 0.7067803151194687 -1.3277072300962867e-07 -0.09981576187450897 +2.3003 0.7067818149465165 0.7067804149920582 -1.3410282593585843e-07 -0.09981581779107968 +2.3004000000000002 0.7067819128159274 0.7067805148486865 -1.3541354071736067e-07 -0.09981587369069525 +2.3005 0.7067820106415412 0.7067806146891291 -1.36702571632355e-07 -0.09981592957336083 +2.3005999999999998 0.7067821084236037 0.7067807145131586 -1.3796962804006607e-07 -0.09981598543908153 +2.3007000000000004 0.7067822061623634 0.706780814320545 -1.3921442447266397e-07 -0.09981604128786248 +2.3008 0.7067823038580718 0.7067809141110544 -1.4043668066301973e-07 -0.09981609711970885 +2.3009 0.7067824015109838 0.7067810138844508 -1.416361216418499e-07 -0.09981615293462573 +2.301 0.7067824991213563 0.7067811136404948 -1.4281247776720685e-07 -0.09981620873261826 +2.3011 0.7067825966894499 0.7067812133789442 -1.4396548480254123e-07 -0.09981626451369155 +2.3012 0.7067826942155273 0.7067813130995539 -1.450948839895605e-07 -0.09981632027785067 +2.3013000000000003 0.7067827916998545 0.706781412802077 -1.462004220707802e-07 -0.09981637602510082 +2.3014 0.7067828891426996 0.7067815124862626 -1.472818513866686e-07 -0.09981643175544705 +2.3015 0.7067829865443338 0.7067816121518582 -1.4833892988952435e-07 -0.09981648746889454 +2.3016 0.7067830839050304 0.7067817117986084 -1.4937142123715164e-07 -0.09981654316544836 +2.3017000000000003 0.7067831812250656 0.7067818114262552 -1.503790948102074e-07 -0.09981659884511367 +2.3018 0.7067832785047174 0.7067819110345385 -1.5136172579199858e-07 -0.09981665450789552 +2.3019000000000003 0.706783375744267 0.7067820106231957 -1.5231909521185028e-07 -0.09981671015379906 +2.302 0.7067834729439966 0.7067821101919622 -1.532509899780654e-07 -0.09981676578282941 +2.3021 0.706783570104192 0.7067822097405705 -1.5415720294037483e-07 -0.09981682139499165 +2.3022000000000005 0.7067836672251402 0.7067823092687515 -1.5503753293504008e-07 -0.09981687699029089 +2.3023000000000002 0.7067837643071306 0.706782408776234 -1.5589178482822152e-07 -0.09981693256873224 +2.3024 0.7067838613504549 0.7067825082627448 -1.5671976955240752e-07 -0.09981698813032079 +2.3025 0.7067839583554063 0.7067826077280082 -1.5752130415498666e-07 -0.09981704367506167 +2.3026 0.7067840553222797 0.7067827071717472 -1.582962118260034e-07 -0.09981709920295995 +2.3027 0.7067841522513728 0.7067828065936825 -1.5904432196407747e-07 -0.09981715471402071 +2.3028000000000004 0.7067842491429841 0.706782905993534 -1.5976547019201648e-07 -0.09981721020824913 +2.3029 0.7067843459974139 0.7067830053710187 -1.6045949839671447e-07 -0.0998172656856502 +2.303 0.7067844428149648 0.7067831047258526 -1.6112625476905063e-07 -0.09981732114622904 +2.3030999999999997 0.7067845395959402 0.7067832040577501 -1.6176559382297118e-07 -0.09981737658999082 +2.3032000000000004 0.7067846363406451 0.7067833033664241 -1.6237737644232697e-07 -0.09981743201694054 +2.3033 0.7067847330493864 0.7067834026515862 -1.6296146991036375e-07 -0.09981748742708335 +2.3034 0.7067848297224717 0.706783501912946 -1.635177479565597e-07 -0.09981754282042427 +2.3035 0.7067849263602104 0.7067836011502131 -1.640460907149921e-07 -0.09981759819696845 +2.3036 0.706785022962913 0.7067837003630946 -1.6454638481974704e-07 -0.09981765355672095 +2.3037 0.7067851195308905 0.7067837995512969 -1.6501852340145007e-07 -0.0998177088996868 +2.3038000000000003 0.7067852160644561 0.7067838987145256 -1.6546240612716479e-07 -0.09981776422587119 +2.3039 0.7067853125639232 0.706783997852485 -1.6587793920733174e-07 -0.0998178195352791 +2.304 0.706785409029606 0.7067840969648788 -1.662650353940337e-07 -0.09981787482791563 +2.3041 0.7067855054618201 0.7067841960514094 -1.666236140347721e-07 -0.0998179301037859 +2.3042000000000002 0.7067856018608817 0.7067842951117789 -1.6695360107940593e-07 -0.09981798536289496 +2.3043 0.7067856982271075 0.7067843941456879 -1.672549291079073e-07 -0.09981804060524785 +2.3044000000000002 0.7067857945608149 0.7067844931528374 -1.6752753729913639e-07 -0.09981809583084968 +2.3045 0.7067858908623225 0.7067845921329273 -1.6777137148635268e-07 -0.09981815103970557 +2.3045999999999998 0.7067859871319482 0.7067846910856568 -1.679863841433371e-07 -0.09981820623182049 +2.3047000000000004 0.7067860833700113 0.7067847900107249 -1.681725344104129e-07 -0.09981826140719957 +2.3048 0.7067861795768309 0.7067848889078301 -1.6832978810832344e-07 -0.09981831656584782 +2.3049 0.7067862757527269 0.706784987776671 -1.6845811770874186e-07 -0.09981837170777036 +2.305 0.7067863718980191 0.7067850866169454 -1.6855750236376144e-07 -0.0998184268329722 +2.3051 0.7067864680130274 0.7067851854283516 -1.6862792790589554e-07 -0.09981848194145852 +2.3052 0.7067865640980716 0.7067852842105871 -1.6866938685848598e-07 -0.09981853703323422 +2.3053000000000003 0.7067866601534719 0.7067853829633501 -1.6868187842355997e-07 -0.09981859210830445 +2.3054 0.7067867561795482 0.7067854816863387 -1.686654084748912e-07 -0.09981864716667424 +2.3055 0.7067868521766205 0.7067855803792504 -1.686199895545304e-07 -0.09981870220834864 +2.3056 0.706786948145008 0.706785679041784 -1.685456408866831e-07 -0.09981875723333271 +2.3057000000000003 0.7067870440850302 0.7067857776736381 -1.6844238836036252e-07 -0.0998188122416315 +2.3058 0.7067871399970063 0.7067858762745118 -1.6831026453112408e-07 -0.09981886723325015 +2.3059000000000003 0.7067872358812542 0.7067859748441041 -1.6814930857249333e-07 -0.09981892220819355 +2.306 0.7067873317380923 0.706786073382115 -1.6795956630372144e-07 -0.09981897716646682 +2.3061 0.7067874275678379 0.7067861718882452 -1.6774109018284633e-07 -0.09981903210807505 +2.3062000000000005 0.7067875233708079 0.7067862703621957 -1.6749393927199818e-07 -0.09981908703302322 +2.3063000000000002 0.7067876191473179 0.7067863688036681 -1.6721817921658277e-07 -0.0998191419413164 +2.3064 0.7067877148976835 0.7067864672123652 -1.669138822314037e-07 -0.09981919683295962 +2.3065 0.706787810622219 0.7067865655879904 -1.6658112710933592e-07 -0.09981925170795791 +2.3066 0.7067879063212379 0.7067866639302482 -1.6621999915887586e-07 -0.09981930656631634 +2.3067 0.7067880019950525 0.706786762238844 -1.6583059023189684e-07 -0.09981936140803992 +2.3068 0.7067880976439744 0.7067868605134842 -1.6541299865079073e-07 -0.0998194162331337 +2.3069 0.706788193268314 0.7067869587538761 -1.649673292067333e-07 -0.09981947104160271 +2.307 0.7067882888683799 0.7067870569597288 -1.644936931458063e-07 -0.09981952583345197 +2.3070999999999997 0.7067883844444799 0.7067871551307523 -1.6399220812042536e-07 -0.09981958060868655 +2.3072000000000004 0.7067884799969208 0.7067872532666581 -1.6346299816852317e-07 -0.09981963536731145 +2.3073 0.7067885755260073 0.7067873513671588 -1.6290619367712034e-07 -0.09981969010933169 +2.3074 0.706788671032043 0.7067874494319686 -1.6232193136150874e-07 -0.09981974483475226 +2.3075 0.7067887665153301 0.7067875474608034 -1.6171035422535285e-07 -0.09981979954357827 +2.3076 0.7067888619761685 0.706787645453381 -1.6107161154160776e-07 -0.09981985423581471 +2.3077 0.7067889574148574 0.7067877434094203 -1.604058587761914e-07 -0.09981990891146661 +2.3078000000000003 0.7067890528316931 0.7067878413286419 -1.5971325758451504e-07 -0.09981996357053895 +2.3079 0.7067891482269713 0.7067879392107684 -1.5899397577331942e-07 -0.09982001821303675 +2.308 0.706789243600985 0.7067880370555246 -1.5824818723648992e-07 -0.09982007283896507 +2.3081 0.7067893389540254 0.706788134862637 -1.5747607193597468e-07 -0.09982012744832888 +2.3082000000000003 0.7067894342863821 0.706788232631834 -1.5667781584280394e-07 -0.09982018204113324 +2.3083 0.7067895295983418 0.7067883303628462 -1.558536108971914e-07 -0.09982023661738312 +2.3084000000000002 0.7067896248901903 0.706788428055406 -1.5500365496690094e-07 -0.09982029117708359 +2.3085 0.7067897201622098 0.7067885257092488 -1.541281518108173e-07 -0.09982034572023962 +2.3085999999999998 0.7067898154146812 0.7067886233241112 -1.532273109939447e-07 -0.09982040024685619 +2.3087000000000004 0.7067899106478825 0.7067887208997328 -1.5230134787005967e-07 -0.09982045475693835 +2.3088 0.7067900058620902 0.7067888184358556 -1.51350483524465e-07 -0.0998205092504911 +2.3089 0.706790101057577 0.7067889159322239 -1.5037494471500934e-07 -0.0998205637275194 +2.309 0.7067901962346144 0.7067890133885844 -1.4937496380790227e-07 -0.09982061818802833 +2.3091 0.7067902913934705 0.706789110804686 -1.4835077873781577e-07 -0.09982067263202278 +2.3092 0.706790386534411 0.7067892081802813 -1.4730263296798551e-07 -0.09982072705950785 +2.3093000000000004 0.7067904816576989 0.7067893055151249 -1.4623077539133167e-07 -0.09982078147048846 +2.3094 0.7067905767635951 0.7067894028089736 -1.4513546029923385e-07 -0.0998208358649697 +2.3095 0.7067906718523564 0.706789500061588 -1.440169473121422e-07 -0.09982089024295648 +2.3096 0.7067907669242379 0.7067895972727314 -1.4287550132580096e-07 -0.09982094460445384 +2.3097000000000003 0.7067908619794911 0.706789694442169 -1.4171139244532893e-07 -0.09982099894946672 +2.3098 0.7067909570183653 0.7067897915696703 -1.4052489590889172e-07 -0.09982105327800021 +2.3099000000000003 0.7067910520411057 0.7067898886550068 -1.3931629203565998e-07 -0.09982110759005919 +2.31 0.7067911470479551 0.7067899856979537 -1.380858661650941e-07 -0.0998211618856487 +2.3101 0.7067912420391531 0.7067900826982891 -1.368339085736775e-07 -0.0998212161647737 +2.3102000000000005 0.7067913370149361 0.706790179655794 -1.3556071442114015e-07 -0.0998212704274392 +2.3103000000000002 0.7067914319755375 0.7067902765702533 -1.342665836671919e-07 -0.09982132467365015 +2.3104 0.7067915269211866 0.7067903734414545 -1.3295182101774605e-07 -0.09982137890341154 +2.3105 0.7067916218521104 0.7067904702691887 -1.3161673582604005e-07 -0.0998214331167284 +2.3106 0.706791716768532 0.7067905670532505 -1.3026164206141055e-07 -0.09982148731360564 +2.3107 0.7067918116706708 0.7067906637934378 -1.2888685818959744e-07 -0.09982154149404826 +2.3108 0.7067919065587434 0.7067907604895519 -1.2749270713284522e-07 -0.09982159565806126 +2.3109 0.7067920014329625 0.7067908571413978 -1.2607951617969737e-07 -0.09982164980564957 +2.311 0.7067920962935371 0.7067909537487839 -1.246476169051991e-07 -0.09982170393681822 +2.3110999999999997 0.7067921911406729 0.7067910503115222 -1.2319734509977365e-07 -0.09982175805157217 +2.3112000000000004 0.7067922859745717 0.7067911468294286 -1.217290406807514e-07 -0.09982181214991633 +2.3113 0.7067923807954315 0.7067912433023222 -1.2024304764206295e-07 -0.09982186623185568 +2.3114 0.7067924756034467 0.7067913397300265 -1.1873971393107363e-07 -0.09982192029739523 +2.3115 0.7067925703988083 0.7067914361123684 -1.1721939139654192e-07 -0.0998219743465399 +2.3116 0.7067926651817028 0.7067915324491783 -1.1568243568974013e-07 -0.09982202837929466 +2.3117 0.7067927599523132 0.7067916287402912 -1.1412920620547384e-07 -0.0998220823956645 +2.3118000000000003 0.7067928547108187 0.7067917249855458 -1.1256006596759016e-07 -0.09982213639565438 +2.3119 0.7067929494573941 0.7067918211847841 -1.1097538156132347e-07 -0.09982219037926923 +2.312 0.7067930441922109 0.7067919173378527 -1.0937552304655929e-07 -0.09982224434651402 +2.3121 0.706793138915436 0.7067920134446022 -1.0776086387803696e-07 -0.09982229829739372 +2.3122000000000003 0.7067932336272322 0.706792109504887 -1.0613178080039892e-07 -0.09982235223191323 +2.3123 0.7067933283277588 0.7067922055185656 -1.0448865377359756e-07 -0.09982240615007754 +2.3124000000000002 0.7067934230171704 0.7067923014855009 -1.0283186587488335e-07 -0.09982246005189162 +2.3125 0.7067935176956177 0.7067923974055597 -1.0116180322421175e-07 -0.0998225139373604 +2.3125999999999998 0.7067936123632474 0.7067924932786129 -9.947885488102715e-08 -0.09982256780648883 +2.3127000000000004 0.7067937070202016 0.7067925891045361 -9.778341275579194e-08 -0.0998226216592819 +2.3128 0.7067938016666182 0.7067926848832085 -9.607587152238306e-08 -0.09982267549574443 +2.3129 0.7067938963026313 0.7067927806145137 -9.435662853395782e-08 -0.09982272931588149 +2.313 0.7067939909283699 0.70679287629834 -9.262608371193165e-08 -0.0998227831196979 +2.3131 0.7067940855439594 0.7067929719345798 -9.088463946010927e-08 -0.09982283690719872 +2.3132 0.7067941801495204 0.7067930675231298 -8.913270058402006e-08 -0.09982289067838884 +2.3133000000000004 0.7067942747451696 0.7067931630638911 -8.737067417989575e-08 -0.09982294443327322 +2.3134 0.7067943693310186 0.7067932585567691 -8.559896954880158e-08 -0.09982299817185675 +2.3135 0.7067944639071753 0.7067933540016739 -8.381799809688978e-08 -0.09982305189414438 +2.3136 0.7067945584737425 0.7067934493985195 -8.202817324692857e-08 -0.09982310560014107 +2.3137000000000003 0.7067946530308191 0.7067935447472251 -8.022991033595356e-08 -0.09982315928985173 +2.3138 0.7067947475784995 0.7067936400477138 -7.842362652245999e-08 -0.0998232129632813 +2.3139000000000003 0.7067948421168728 0.7067937352999134 -7.660974068318671e-08 -0.09982326662043473 +2.314 0.7067949366460242 0.7067938305037563 -7.478867332638e-08 -0.09982332026131685 +2.3141 0.7067950311660347 0.7067939256591792 -7.296084648640913e-08 -0.09982337388593267 +2.3142000000000005 0.7067951256769802 0.7067940207661236 -7.112668363182598e-08 -0.09982342749428715 +2.3143000000000002 0.7067952201789323 0.7067941158245357 -6.928660955824589e-08 -0.09982348108638517 +2.3144 0.7067953146719578 0.7067942108343653 -6.744105030161152e-08 -0.09982353466223164 +2.3145 0.7067954091561187 0.7067943057955681 -6.559043303237463e-08 -0.09982358822183142 +2.3146 0.706795503631473 0.7067944007081035 -6.373518595705063e-08 -0.09982364176518954 +2.3147 0.7067955980980738 0.7067944955719361 -6.187573821890557e-08 -0.09982369529231082 +2.3148 0.7067956925559696 0.7067945903870346 -6.001251980341377e-08 -0.09982374880320023 +2.3149 0.7067957870052042 0.7067946851533726 -5.814596143504172e-08 -0.0998238022978627 +2.315 0.7067958814458168 0.7067947798709285 -5.627649447750155e-08 -0.09982385577630311 +2.3150999999999997 0.7067959758778422 0.7067948745396848 -5.440455083226964e-08 -0.09982390923852638 +2.3152000000000004 0.7067960703013099 0.7067949691596291 -5.253056284512843e-08 -0.09982396268453742 +2.3153 0.7067961647162455 0.7067950637307534 -5.0654963202083e-08 -0.09982401611434111 +2.3154 0.7067962591226695 0.706795158253055 -4.8778184829289216e-08 -0.09982406952794243 +2.3155 0.7067963535205977 0.7067952527265344 -4.6900660792006076e-08 -0.09982412292534619 +2.3156 0.7067964479100417 0.7067953471511983 -4.50228241995654e-08 -0.09982417630655734 +2.3157 0.7067965422910083 0.7067954415270572 -4.3145108101396833e-08 -0.0998242296715808 +2.3158000000000003 0.7067966366634992 0.7067955358541264 -4.126794538898888e-08 -0.09982428302042146 +2.3159 0.7067967310275117 0.7067956301324259 -3.939176869400098e-08 -0.09982433635308416 +2.316 0.7067968253830389 0.7067957243619805 -3.751701029214901e-08 -0.0998243896695739 +2.3161 0.7067969197300685 0.706795818542819 -3.5644101999826594e-08 -0.0998244429698955 +2.3162000000000003 0.7067970140685841 0.7067959126749759 -3.3773475077367165e-08 -0.09982449625405386 +2.3163 0.7067971083985647 0.7067960067584894 -3.190556012878237e-08 -0.09982454952205393 +2.3164000000000002 0.7067972027199843 0.7067961007934025 -3.004078700250337e-08 -0.09982460277390054 +2.3165 0.7067972970328125 0.706796194779763 -2.8179584692826845e-08 -0.09982465600959857 +2.3165999999999998 0.7067973913370141 0.7067962887176231 -2.6322381240818926e-08 -0.09982470922915293 +2.3167000000000004 0.7067974856325501 0.7067963826070401 -2.4469603636737003e-08 -0.09982476243256856 +2.3168 0.7067975799193759 0.7067964764480752 -2.262167772115048e-08 -0.09982481561985032 +2.3169 0.7067976741974429 0.7067965702407945 -2.0779028089314144e-08 -0.09982486879100305 +2.317 0.7067977684666978 0.7067966639852684 -1.8942077989470008e-08 -0.0998249219460317 +2.3171 0.706797862727083 0.7067967576815719 -1.7111249226136466e-08 -0.09982497508494105 +2.3172 0.7067979569785358 0.7067968513297849 -1.5286962069469e-08 -0.09982502820773607 +2.3173000000000004 0.7067980512209895 0.7067969449299912 -1.3469635156380944e-08 -0.09982508131442157 +2.3174 0.706798145454373 0.7067970384822797 -1.1659685383424295e-08 -0.0998251344050025 +2.3175 0.7067982396786106 0.706797131986743 -9.85752782612509e-09 -0.09982518747948366 +2.3176 0.7067983338936219 0.7067972254434786 -8.063575638803111e-09 -0.09982524053786995 +2.3177000000000003 0.7067984280993225 0.7067973188525885 -6.27823995829474e-09 -0.09982529358016624 +2.3178 0.7067985222956233 0.7067974122141789 -4.501929809844207e-09 -0.09982534660637749 +2.3179000000000003 0.7067986164824311 0.7067975055283606 -2.7350520138622048e-09 -0.09982539961650848 +2.318 0.7067987106596483 0.7067975987952482 -9.780110983223511e-10 -0.09982545261056408 +2.3181 0.7067988048271725 0.7067976920149611 7.687908079243022e-10 -0.09982550558854919 +2.3182000000000005 0.7067988989848976 0.7067977851876228 2.5049540540791893e-09 -0.09982555855046861 +2.3183000000000002 0.7067989931327132 0.7067978783133609 4.230081561071297e-09 -0.0998256114963273 +2.3184 0.7067990872705043 0.7067979713923076 5.943778915232234e-09 -0.09982566442613003 +2.3185 0.706799181398152 0.706798064424599 7.64565445850185e-09 -0.09982571733988166 +2.3186 0.7067992755155332 0.7067981574103757 9.335319374297046e-09 -0.09982577023758717 +2.3187 0.7067993696225205 0.706798250349782 1.101238778118685e-08 -0.09982582311925131 +2.3188 0.7067994637189826 0.706798343242967 1.267647681529177e-08 -0.099825875984879 +2.3189 0.7067995578047839 0.7067984360900824 1.4327206729163044e-08 -0.09982592883447501 +2.319 0.7067996518797846 0.7067985288912855 1.5964200962906294e-08 -0.09982598166804423 +2.3190999999999997 0.7067997459438415 0.7067986216467371 1.7587086235254512e-08 -0.09982603448559152 +2.3192000000000004 0.7067998399968071 0.7067987143566018 1.9195492637243128e-08 -0.09982608728712172 +2.3193 0.7067999340385298 0.7067988070210482 2.078905370767048e-08 -0.09982614007263971 +2.3194 0.7068000280688542 0.706798899640249 2.2367406513762456e-08 -0.09982619284215032 +2.3195 0.7068001220876214 0.7067989922143801 2.393019174311284e-08 -0.09982624559565836 +2.3196 0.7068002160946681 0.7067990847436223 2.5477053789552118e-08 -0.09982629833316874 +2.3197 0.7068003100898279 0.706799177228159 2.7007640812995448e-08 -0.09982635105468628 +2.3198000000000003 0.7068004040729299 0.7067992696681779 2.8521604831382996e-08 -0.09982640376021579 +2.3199 0.7068004980438002 0.7067993620638706 3.001860181088556e-08 -0.09982645644976215 +2.32 0.7068005920022606 0.7067994544154321 3.149829172315044e-08 -0.09982650912333019 +2.3201 0.70680068594813 0.7067995467230607 3.2960338638976516e-08 -0.09982656178092472 +2.3202000000000003 0.7068007798812233 0.7067996389869589 3.440441079770318e-08 -0.09982661442255064 +2.3203 0.7068008738013516 0.7067997312073317 3.58301806939465e-08 -0.09982666704821269 +2.3204000000000002 0.7068009677083235 0.7067998233843888 3.7237325110558994e-08 -0.09982671965791573 +2.3205 0.7068010616019431 0.7067999155183426 3.8625525250468584e-08 -0.09982677225166463 +2.3205999999999998 0.706801155482012 0.7068000076094091 3.999446677484253e-08 -0.0998268248294642 +2.3207000000000004 0.7068012493483277 0.7068000996578073 4.134383987247636e-08 -0.09982687739131929 +2.3208 0.7068013432006852 0.7068001916637597 4.267333934306061e-08 -0.0998269299372347 +2.3209 0.7068014370388757 0.706800283627492 4.398266465789613e-08 -0.09982698246721526 +2.321 0.7068015308626874 0.7068003755492331 4.52715200344872e-08 -0.09982703498126581 +2.3211 0.7068016246719054 0.706800467429215 4.6539614497256854e-08 -0.09982708747939113 +2.3212 0.706801718466312 0.7068005592676727 4.778666194520109e-08 -0.09982713996159609 +2.3213000000000004 0.7068018122456861 0.706800651064844 4.9012381217808376e-08 -0.09982719242788549 +2.3214 0.7068019060098035 0.7068007428209702 5.0216496154040224e-08 -0.09982724487826411 +2.3215 0.7068019997584376 0.7068008345362953 5.139873565478126e-08 -0.09982729731273682 +2.3216 0.7068020934913588 0.7068009262110657 5.2558833753962864e-08 -0.09982734973130845 +2.3217000000000003 0.7068021872083347 0.7068010178455311 5.3696529668870174e-08 -0.09982740213398379 +2.3218 0.7068022809091297 0.7068011094399438 5.481156785565322e-08 -0.09982745452076762 +2.3219000000000003 0.706802374593506 0.7068012009945586 5.5903698082185316e-08 -0.09982750689166477 +2.322 0.7068024682612235 0.706801292509633 5.697267545408391e-08 -0.09982755924668008 +2.3221 0.7068025619120386 0.7068013839854272 5.801826051012038e-08 -0.0998276115858183 +2.3222000000000005 0.7068026555457061 0.7068014754222041 5.90402192499756e-08 -0.09982766390908429 +2.3223000000000003 0.7068027491619777 0.7068015668202281 6.003832318628166e-08 -0.09982771621648281 +2.3224 0.706802842760603 0.7068016581797671 6.101234939839828e-08 -0.0998277685080187 +2.3225 0.7068029363413293 0.7068017495010908 6.196208058098507e-08 -0.09982782078369672 +2.3226 0.7068030299039016 0.7068018407844713 6.288730511859464e-08 -0.09982787304352173 +2.3227 0.7068031234480627 0.7068019320301828 6.378781708914205e-08 -0.0998279252874985 +2.3228 0.706803216973553 0.7068020232385015 6.466341633329376e-08 -0.0998279775156318 +2.3229 0.7068033104801114 0.7068021144097061 6.551390850824401e-08 -0.09982802972792648 +2.323 0.7068034039674742 0.7068022055440768 6.633910510679686e-08 -0.09982808192438733 +2.3230999999999997 0.7068034974353763 0.7068022966418961 6.713882350246891e-08 -0.09982813410501909 +2.3232000000000004 0.7068035908835499 0.7068023877034483 6.79128870171436e-08 -0.09982818626982662 +2.3233 0.7068036843117264 0.7068024787290194 6.866112493668364e-08 -0.09982823841881466 +2.3234 0.7068037777196345 0.7068025697188971 6.93833725421561e-08 -0.099828290551988 +2.3235 0.7068038711070017 0.7068026606733715 7.007947116881297e-08 -0.09982834266935148 +2.3236 0.706803964473554 0.7068027515927333 7.074926824078565e-08 -0.09982839477090986 +2.3237 0.7068040578190153 0.7068028424772753 7.139261725373769e-08 -0.09982844685666786 +2.3238000000000003 0.7068041511431085 0.7068029333272918 7.200937787547879e-08 -0.09982849892663033 +2.3239 0.7068042444455548 0.7068030241430784 7.259941594596475e-08 -0.09982855098080204 +2.324 0.7068043377260742 0.7068031149249322 7.316260348770587e-08 -0.09982860301918778 +2.3241 0.7068044309843851 0.7068032056731514 7.36988187734211e-08 -0.09982865504179228 +2.3242000000000003 0.7068045242202052 0.7068032963880357 7.420794632430339e-08 -0.09982870704862042 +2.3243 0.7068046174332505 0.7068033870698858 7.468987694297935e-08 -0.0998287590396769 +2.3244000000000002 0.7068047106232364 0.7068034777190031 7.514450772391768e-08 -0.09982881101496648 +2.3245 0.7068048037898764 0.7068035683356909 7.557174210373607e-08 -0.09982886297449395 +2.3245999999999998 0.7068048969328843 0.7068036589202527 7.597148985773183e-08 -0.09982891491826411 +2.3247000000000004 0.7068049900519718 0.7068037494729933 7.634366712243323e-08 -0.09982896684628169 +2.3248 0.7068050831468509 0.706803839994218 7.668819642682456e-08 -0.09982901875855153 +2.3249 0.7068051762172318 0.7068039304842333 7.700500668714194e-08 -0.09982907065507833 +2.325 0.7068052692628244 0.7068040209433459 7.729403323636364e-08 -0.09982912253586684 +2.3251 0.7068053622833383 0.7068041113718635 7.755521783288366e-08 -0.09982917440092193 +2.3252 0.7068054552784826 0.7068042017700938 7.778850868479792e-08 -0.09982922625024826 +2.3253000000000004 0.7068055482479649 0.7068042921383455 7.79938604204139e-08 -0.0998292780838506 +2.3254 0.7068056411914936 0.7068043824769278 7.81712341350882e-08 -0.09982932990173372 +2.3255 0.7068057341087763 0.7068044727861498 7.832059740857378e-08 -0.09982938170390246 +2.3256 0.7068058269995201 0.7068045630663209 7.844192425124352e-08 -0.09982943349036147 +2.3257000000000003 0.7068059198634322 0.706804653317751 7.853519516654028e-08 -0.09982948526111557 +2.3258 0.7068060127002196 0.7068047435407498 7.860039713883382e-08 -0.09982953701616945 +2.3259000000000003 0.7068061055095891 0.7068048337356274 7.863752361433884e-08 -0.09982958875552791 +2.326 0.7068061982912477 0.7068049239026937 7.864657451325807e-08 -0.09982964047919571 +2.3261 0.7068062910449024 0.7068050140422585 7.862755624539475e-08 -0.0998296921871776 +2.3262000000000005 0.7068063837702605 0.7068051041546315 7.858048168066234e-08 -0.09982974387947832 +2.3263000000000003 0.706806476467029 0.7068051942401221 7.850537014214565e-08 -0.09982979555610261 +2.3264 0.7068065691349159 0.7068052842990393 7.840224743385638e-08 -0.09982984721705519 +2.3265 0.7068066617736292 0.7068053743316922 7.827114579042616e-08 -0.0998298988623409 +2.3266 0.7068067543828769 0.7068054643383891 7.811210390659684e-08 -0.09982995049196436 +2.3267 0.7068068469623683 0.7068055543194377 7.792516689558715e-08 -0.09983000210593035 +2.3268 0.7068069395118126 0.7068056442751456 7.771038628909266e-08 -0.09983005370424368 +2.3269 0.7068070320309201 0.7068057342058192 7.74678200147344e-08 -0.099830105286909 +2.327 0.7068071245194018 0.7068058241117645 7.719753241861027e-08 -0.0998301568539311 +2.3270999999999997 0.706807216976969 0.7068059139932872 7.689959419070191e-08 -0.09983020840531473 +2.3272000000000004 0.706807309403334 0.7068060038506907 7.657408238222196e-08 -0.09983025994106454 +2.3273 0.7068074017982104 0.7068060936842793 7.622108038653208e-08 -0.09983031146118533 +2.3274 0.7068074941613123 0.7068061834943551 7.584067789750959e-08 -0.09983036296568185 +2.3275 0.7068075864923552 0.7068062732812195 7.543297090260859e-08 -0.09983041445455877 +2.3276 0.7068076787910554 0.7068063630451729 7.499806166724743e-08 -0.09983046592782086 +2.3277 0.7068077710571306 0.7068064527865147 7.453605868450175e-08 -0.09983051738547288 +2.3278000000000003 0.7068078632902994 0.7068065425055425 7.404707667163501e-08 -0.09983056882751948 +2.3279 0.7068079554902822 0.7068066322025526 7.353123652846516e-08 -0.09983062025396539 +2.328 0.7068080476568004 0.7068067218778407 7.298866530613957e-08 -0.09983067166481535 +2.3281 0.7068081397895767 0.7068068115317003 7.241949617591004e-08 -0.0998307230600741 +2.3282000000000003 0.7068082318883362 0.706806901164424 7.182386842045918e-08 -0.09983077443974638 +2.3283 0.7068083239528045 0.7068069907763023 7.120192737491982e-08 -0.0998308258038369 +2.3284000000000002 0.706808415982709 0.7068070803676241 7.055382438177216e-08 -0.0998308771523503 +2.3285 0.7068085079777799 0.7068071699386769 6.987971678563965e-08 -0.0998309284852914 +2.3286 0.7068085999377476 0.7068072594897461 6.917976787430835e-08 -0.09983097980266485 +2.3287000000000004 0.7068086918623451 0.7068073490211157 6.845414683709361e-08 -0.09983103110447537 +2.3288 0.7068087837513074 0.7068074385330676 6.770302875269696e-08 -0.09983108239072772 +2.3289 0.7068088756043716 0.7068075280258814 6.692659451114358e-08 -0.0998311336614266 +2.329 0.7068089674212759 0.7068076174998351 6.612503076867948e-08 -0.09983118491657665 +2.3291 0.7068090592017613 0.7068077069552046 6.529852995817986e-08 -0.09983123615618264 +2.3292 0.706809150945571 0.7068077963922634 6.444729016771844e-08 -0.09983128738024923 +2.3293000000000004 0.7068092426524502 0.7068078858112831 6.357151514577164e-08 -0.09983133858878117 +2.3294 0.7068093343221462 0.7068079752125328 6.267141424744216e-08 -0.09983138978178313 +2.3295 0.7068094259544089 0.7068080645962795 6.174720234945752e-08 -0.09983144095925985 +2.3296 0.7068095175489904 0.7068081539627877 6.079909983455756e-08 -0.09983149212121599 +2.3297000000000003 0.7068096091056453 0.7068082433123195 5.982733252730965e-08 -0.09983154326765631 +2.3298 0.7068097006241303 0.7068083326451344 5.883213164206702e-08 -0.09983159439858545 +2.3299000000000003 0.7068097921042055 0.7068084219614893 5.7813733723988125e-08 -0.09983164551400807 +2.33 0.706809883545633 0.7068085112616387 5.677238059872969e-08 -0.09983169661392896 +2.3301 0.7068099749481773 0.7068086005458345 5.570831930305775e-08 -0.09983174769835274 +2.3302000000000005 0.7068100663116066 0.7068086898143257 5.462180203801015e-08 -0.09983179876728412 +2.3303000000000003 0.7068101576356909 0.7068087790673584 5.351308611685479e-08 -0.09983184982072785 +2.3304 0.7068102489202033 0.7068088683051763 5.238243388355768e-08 -0.09983190085868857 +2.3305 0.7068103401649197 0.7068089575280199 5.123011265206756e-08 -0.09983195188117093 +2.3306 0.7068104313696196 0.7068090467361267 5.005639467509093e-08 -0.09983200288817971 +2.3307 0.7068105225340846 0.7068091359297313 4.8861557033069714e-08 -0.09983205387971951 +2.3308 0.7068106136580996 0.7068092251090652 4.764588160816041e-08 -0.09983210485579501 +2.3309 0.7068107047414529 0.706809314274357 4.6409654999232663e-08 -0.09983215581641092 +2.331 0.7068107957839355 0.7068094034258321 4.515316844033723e-08 -0.09983220676157191 +2.3310999999999997 0.706810886785342 0.706809492563713 4.387671777468516e-08 -0.09983225769128272 +2.3312000000000004 0.7068109777454701 0.7068095816882184 4.2580603348829626e-08 -0.09983230860554801 +2.3313 0.7068110686641204 0.7068096707995637 4.126512994674647e-08 -0.09983235950437236 +2.3314 0.7068111595410974 0.7068097598979615 3.993060672738413e-08 -0.09983241038776054 +2.3315 0.7068112503762085 0.7068098489836205 3.857734714833583e-08 -0.09983246125571721 +2.3316 0.7068113411692647 0.7068099380567466 3.720566889471588e-08 -0.099832512108247 +2.3317 0.7068114319200807 0.7068100271175416 3.581589380803607e-08 -0.09983256294535459 +2.3318000000000003 0.7068115226284744 0.7068101161662044 3.4408347787326377e-08 -0.09983261376704472 +2.3319 0.7068116132942672 0.7068102052029297 3.2983360744032186e-08 -0.09983266457332202 +2.332 0.7068117039172841 0.7068102942279089 3.154126651874756e-08 -0.09983271536419108 +2.3321 0.706811794497354 0.7068103832413298 3.0082402773662364e-08 -0.09983276613965664 +2.3322000000000003 0.7068118850343093 0.7068104722433767 2.8607110957867832e-08 -0.09983281689972334 +2.3323 0.7068119755279862 0.7068105612342298 2.7115736184191164e-08 -0.09983286764439586 +2.3324000000000003 0.7068120659782244 0.7068106502140657 2.5608627182358012e-08 -0.09983291837367886 +2.3325 0.7068121563848677 0.7068107391830575 2.4086136207052133e-08 -0.09983296908757698 +2.3326 0.7068122467477638 0.7068108281413742 2.2548618947709764e-08 -0.09983301978609493 +2.3327000000000004 0.7068123370667634 0.7068109170891805 2.0996434447854984e-08 -0.09983307046923728 +2.3328 0.7068124273417224 0.7068110060266382 1.94299450305066e-08 -0.09983312113700876 +2.3329 0.7068125175724995 0.7068110949539044 1.7849516207972538e-08 -0.09983317178941403 +2.333 0.706812607758958 0.7068111838711324 1.625551658990948e-08 -0.09983322242645765 +2.3331 0.706812697900965 0.7068112727784717 1.4648317806995048e-08 -0.09983327304814436 +2.3332 0.7068127879983919 0.7068113616760674 1.3028294427661069e-08 -0.0998333236544788 +2.3333000000000004 0.7068128780511134 0.706811450564061 1.1395823848805997e-08 -0.09983337424546557 +2.3334 0.7068129680590088 0.7068115394425897 9.751286235079593e-09 -0.09983342482110935 +2.3335 0.706813058021962 0.7068116283117863 8.095064416534237e-09 -0.0998334753814148 +2.3336 0.70681314793986 0.70681171717178 6.427543800154034e-09 -0.09983352592638653 +2.3337000000000003 0.706813237812595 0.7068118060226953 4.749112284853363e-09 -0.0998335764560292 +2.3338 0.7068133276400625 0.7068118948646529 3.060160162597636e-09 -0.09983362697034745 +2.3339000000000003 0.7068134174221626 0.706811983697769 1.361080034269213e-09 -0.09983367746934589 +2.334 0.7068135071588 0.706812072522156 -3.4773327446668834e-10 -0.09983372795302924 +2.3341 0.7068135968498828 0.7068121613379212 -2.065882827653742e-09 -0.09983377842140202 +2.3342 0.7068136864953243 0.7068122501451686 -3.792969642361921e-09 -0.09983382887446897 +2.3343000000000003 0.7068137760950415 0.7068123389439971 -5.528592803179244e-09 -0.09983387931223464 +2.3344 0.7068138656489561 0.7068124277345015 -7.2723495472132305e-09 -0.09983392973470372 +2.3345 0.7068139551569939 0.7068125165167727 -9.023835353429155e-09 -0.09983398014188083 +2.3346 0.7068140446190851 0.7068126052908965 -1.0782644046733458e-08 -0.0998340305337706 +2.3347 0.7068141340351644 0.7068126940569548 -1.2548367885143602e-08 -0.09983408091037763 +2.3348 0.7068142234051706 0.7068127828150254 -1.4320597651294731e-08 -0.09983413127170664 +2.3349 0.7068143127290476 0.7068128715651805 -1.6098922753920997e-08 -0.09983418161776214 +2.335 0.7068144020067428 0.7068129603074892 -1.7882931321530626e-08 -0.09983423194854886 +2.3350999999999997 0.7068144912382086 0.7068130490420154 -1.9672210294779946e-08 -0.09983428226407132 +2.3352000000000004 0.7068145804234016 0.7068131377688186 -2.146634552491894e-08 -0.09983433256433417 +2.3353 0.7068146695622832 0.7068132264879543 -2.3264921867899996e-08 -0.0998343828493421 +2.3354 0.7068147586548189 0.706813315199473 -2.5067523280655063e-08 -0.09983443311909966 +2.3355 0.7068148477009788 0.7068134039034208 -2.6873732920842247e-08 -0.09983448337361146 +2.3356 0.7068149367007377 0.7068134925998397 -2.868313323575039e-08 -0.09983453361288214 +2.3357 0.7068150256540746 0.7068135812887668 -3.049530606638248e-08 -0.09983458383691633 +2.3358000000000003 0.7068151145609731 0.706813669970235 -3.230983274004652e-08 -0.09983463404571863 +2.3359 0.7068152034214212 0.7068137586442722 -3.4126294165765306e-08 -0.09983468423929363 +2.336 0.7068152922354114 0.7068138473109025 -3.5944270935866184e-08 -0.09983473441764594 +2.3361 0.7068153810029414 0.7068139359701449 -3.776334341857191e-08 -0.09983478458078023 +2.3362000000000003 0.706815469724012 0.7068140246220143 -3.958309185633779e-08 -0.09983483472870104 +2.3363 0.7068155583986298 0.7068141132665209 -4.140309646418882e-08 -0.09983488486141302 +2.3364000000000003 0.706815647026805 0.7068142019036701 -4.322293752193106e-08 -0.09983493497892076 +2.3365 0.7068157356085532 0.7068142905334633 -4.50421954756872e-08 -0.09983498508122884 +2.3366 0.7068158241438938 0.7068143791558975 -4.686045103216791e-08 -0.09983503516834191 +2.3367000000000004 0.7068159126328509 0.7068144677709645 -4.8677285257171625e-08 -0.09983508524026456 +2.3368 0.7068160010754532 0.7068145563786519 -5.049227966844646e-08 -0.09983513529700135 +2.3369 0.7068160894717336 0.706814644978943 -5.230501633700889e-08 -0.0998351853385569 +2.337 0.7068161778217297 0.7068147335718169 -5.411507798033094e-08 -0.09983523536493583 +2.3371 0.7068162661254834 0.7068148221572472 -5.5922048055852616e-08 -0.09983528537614265 +2.3372 0.7068163543830417 0.7068149107352041 -5.7725510863113755e-08 -0.09983533537218207 +2.3373000000000004 0.7068164425944551 0.706814999305653 -5.952505163515226e-08 -0.09983538535305862 +2.3374 0.706816530759779 0.7068150878685543 -6.132025663152865e-08 -0.09983543531877691 +2.3375 0.7068166188790733 0.7068151764238648 -6.31107132408916e-08 -0.0998354852693415 +2.3376 0.7068167069524021 0.7068152649715365 -6.489601006966564e-08 -0.09983553520475696 +2.3377000000000003 0.7068167949798344 0.7068153535115169 -6.667573703746099e-08 -0.09983558512502796 +2.3378 0.706816882961443 0.7068154420437496 -6.84494854733507e-08 -0.09983563503015906 +2.3379000000000003 0.7068169708973051 0.706815530568173 -7.021684820650992e-08 -0.09983568492015481 +2.338 0.7068170587875025 0.7068156190847219 -7.197741966292678e-08 -0.09983573479501978 +2.3381 0.7068171466321214 0.7068157075933263 -7.373079595821008e-08 -0.09983578465475865 +2.3382 0.706817234431252 0.7068157960939123 -7.547657498475913e-08 -0.0998358344993759 +2.3383000000000003 0.7068173221849889 0.7068158845864012 -7.721435651628084e-08 -0.09983588432887613 +2.3384 0.7068174098934312 0.7068159730707102 -7.894374228108181e-08 -0.09983593414326389 +2.3385 0.7068174975566819 0.7068160615467528 -8.066433607005485e-08 -0.09983598394254384 +2.3386 0.7068175851748487 0.7068161500144372 -8.237574381907836e-08 -0.09983603372672047 +2.3387000000000002 0.706817672748043 0.7068162384736683 -8.407757370442609e-08 -0.09983608349579838 +2.3388 0.7068177602763807 0.7068163269243466 -8.576943622603389e-08 -0.09983613324978219 +2.3389 0.7068178477599814 0.706816415366368 -8.745094429770534e-08 -0.09983618298867636 +2.339 0.7068179351989696 0.7068165037996248 -8.912171334078678e-08 -0.09983623271248557 +2.3390999999999997 0.7068180225934733 0.7068165922240053 -9.078136137003617e-08 -0.09983628242121435 +2.3392000000000004 0.7068181099436245 0.7068166806393931 -9.242950907775715e-08 -0.09983633211486725 +2.3393 0.7068181972495597 0.7068167690456684 -9.406577992400467e-08 -0.09983638179344888 +2.3394 0.7068182845114193 0.7068168574427067 -9.568980021551488e-08 -0.09983643145696376 +2.3395 0.7068183717293473 0.7068169458303806 -9.730119920371705e-08 -0.09983648110541649 +2.3396 0.7068184589034918 0.7068170342085572 -9.889960916192875e-08 -0.09983653073881157 +2.3397 0.7068185460340051 0.7068171225771012 -1.0048466546341839e-07 -0.09983658035715359 +2.3398000000000003 0.7068186331210429 0.7068172109358724 -1.0205600667594766e-07 -0.09983662996044712 +2.3399 0.7068187201647651 0.7068172992847275 -1.0361327463636466e-07 -0.09983667954869672 +2.34 0.7068188071653356 0.7068173876235188 -1.051561145356053e-07 -0.09983672912190694 +2.3401 0.7068188941229213 0.7068174759520949 -1.0668417500022537e-07 -0.09983677868008228 +2.3402000000000003 0.7068189810376936 0.7068175642703012 -1.0819710816612621e-07 -0.09983682822322737 +2.3403 0.7068190679098272 0.7068176525779788 -1.0969456976789305e-07 -0.09983687775134671 +2.3404000000000003 0.7068191547395003 0.7068177408749656 -1.1117621920644916e-07 -0.0998369272644449 +2.3405 0.7068192415268952 0.7068178291610954 -1.1264171963405734e-07 -0.09983697676252641 +2.3406 0.7068193282721975 0.7068179174361988 -1.1409073803411718e-07 -0.09983702624559587 +2.3407000000000004 0.7068194149755962 0.7068180057001028 -1.1552294527580886e-07 -0.09983707571365776 +2.3408 0.7068195016372841 0.7068180939526307 -1.1693801621817657e-07 -0.09983712516671665 +2.3409 0.7068195882574573 0.706818182193603 -1.1833562975870071e-07 -0.09983717460477715 +2.341 0.706819674836315 0.7068182704228361 -1.1971546892870777e-07 -0.0998372240278437 +2.3411 0.7068197613740601 0.706818358640143 -1.2107722095061613e-07 -0.09983727343592089 +2.3412 0.7068198478708986 0.7068184468453338 -1.2242057730212086e-07 -0.0998373228290132 +2.3413000000000004 0.7068199343270399 0.7068185350382153 -1.2374523380813407e-07 -0.09983737220712524 +2.3414 0.7068200207426967 0.7068186232185912 -1.2505089068415298e-07 -0.09983742157026153 +2.3415 0.7068201071180849 0.7068187113862615 -1.2633725262820028e-07 -0.09983747091842661 +2.3416 0.7068201934534226 0.7068187995410238 -1.2760402888153943e-07 -0.099837520251625 +2.3417000000000003 0.7068202797489324 0.7068188876826718 -1.2885093327030805e-07 -0.09983756956986119 +2.3418 0.7068203660048389 0.7068189758109968 -1.3007768430960132e-07 -0.09983761887313977 +2.3419 0.70682045222137 0.7068190639257872 -1.3128400522428862e-07 -0.09983766816146526 +2.342 0.7068205383987569 0.7068191520268279 -1.324696240513623e-07 -0.09983771743484221 +2.3421 0.7068206245372325 0.7068192401139015 -1.3363427367983627e-07 -0.09983776669327507 +2.3422 0.7068207106370338 0.7068193281867874 -1.3477769190452238e-07 -0.0998378159367684 +2.3423000000000003 0.7068207966983997 0.7068194162452623 -1.3589962150756252e-07 -0.09983786516532672 +2.3424 0.7068208827215725 0.7068195042891008 -1.3699981030006192e-07 -0.0998379143789546 +2.3425 0.7068209687067966 0.706819592318074 -1.3807801117760032e-07 -0.09983796357765652 +2.3426 0.7068210546543188 0.7068196803319508 -1.3913398218962092e-07 -0.099838012761437 +2.3427000000000002 0.7068211405643889 0.7068197683304975 -1.401674865741248e-07 -0.09983806193030054 +2.3428 0.7068212264372593 0.7068198563134782 -1.411782928235905e-07 -0.09983811108425171 +2.3429 0.7068213122731843 0.7068199442806541 -1.421661747335462e-07 -0.09983816022329496 +2.343 0.7068213980724212 0.7068200322317844 -1.431309114528767e-07 -0.09983820934743488 +2.3430999999999997 0.7068214838352285 0.7068201201666259 -1.4407228754800827e-07 -0.09983825845667593 +2.3432000000000004 0.7068215695618683 0.7068202080849326 -1.4499009301852106e-07 -0.09983830755102258 +2.3433 0.7068216552526039 0.7068202959864576 -1.45884123373477e-07 -0.09983835663047941 +2.3434 0.7068217409077013 0.7068203838709507 -1.467541796539712e-07 -0.09983840569505095 +2.3435 0.7068218265274282 0.7068204717381602 -1.476000685007861e-07 -0.09983845474474168 +2.3436 0.7068219121120545 0.7068205595878319 -1.4842160219429024e-07 -0.09983850377955605 +2.3437 0.7068219976618517 0.7068206474197103 -1.4921859865270337e-07 -0.0998385527994986 +2.3438000000000003 0.7068220831770938 0.7068207352335374 -1.4999088154138418e-07 -0.09983860180457388 +2.3439 0.7068221686580565 0.706820823029054 -1.5073828025548297e-07 -0.09983865079478636 +2.344 0.7068222541050164 0.7068209108059985 -1.5146062999973897e-07 -0.09983869977014051 +2.3441 0.7068223395182527 0.7068209985641081 -1.5215777179021506e-07 -0.09983874873064084 +2.3442000000000003 0.7068224248980463 0.7068210863031179 -1.5282955249766583e-07 -0.09983879767629188 +2.3443 0.706822510244679 0.7068211740227621 -1.534758249117224e-07 -0.09983884660709813 +2.3444000000000003 0.7068225955584344 0.7068212617227725 -1.5409644771487152e-07 -0.09983889552306402 +2.3445 0.706822680839598 0.7068213494028802 -1.5469128556919176e-07 -0.09983894442419414 +2.3446 0.7068227660884558 0.7068214370628146 -1.5526020911982297e-07 -0.09983899331049292 +2.3447000000000005 0.7068228513052959 0.7068215247023039 -1.558030950209871e-07 -0.09983904218196483 +2.3448 0.7068229364904072 0.7068216123210748 -1.563198259758869e-07 -0.09983909103861445 +2.3449 0.7068230216440796 0.7068216999188529 -1.5681029074364472e-07 -0.09983913988044615 +2.345 0.7068231067666049 0.7068217874953632 -1.5727438418093598e-07 -0.09983918870746449 +2.3451 0.706823191858275 0.706821875050329 -1.5771200725586687e-07 -0.09983923751967394 +2.3452 0.7068232769193837 0.7068219625834726 -1.5812306707052581e-07 -0.09983928631707899 +2.3453000000000004 0.7068233619502251 0.7068220500945159 -1.5850747686965705e-07 -0.0998393350996841 +2.3454 0.7068234469510943 0.7068221375831795 -1.58865156082294e-07 -0.09983938386749379 +2.3455 0.7068235319222872 0.7068222250491834 -1.5919603032349405e-07 -0.0998394326205125 +2.3456 0.7068236168641004 0.7068223124922468 -1.5950003140127733e-07 -0.09983948135874471 +2.3457000000000003 0.7068237017768313 0.7068223999120882 -1.5977709735826018e-07 -0.09983953008219495 +2.3458 0.7068237866607777 0.7068224873084258 -1.6002717243869535e-07 -0.09983957879086763 +2.3459 0.706823871516238 0.7068225746809771 -1.602502071595957e-07 -0.09983962748476732 +2.346 0.706823956343511 0.7068226620294586 -1.604461582691008e-07 -0.09983967616389838 +2.3461 0.706824041142896 0.7068227493535875 -1.6061498877596725e-07 -0.09983972482826535 +2.3462 0.7068241259146923 0.7068228366530797 -1.6075666795477284e-07 -0.09983977347787265 +2.3463000000000003 0.7068242106592002 0.7068229239276513 -1.608711713424471e-07 -0.0998398221127248 +2.3464 0.7068242953767193 0.706823011177018 -1.6095848076602692e-07 -0.09983987073282624 +2.3465 0.7068243800675498 0.7068230984008959 -1.6101858430969673e-07 -0.09983991933818143 +2.3466 0.7068244647319919 0.7068231855990006 -1.6105147635295247e-07 -0.0998399679287949 +2.3467000000000002 0.7068245493703454 0.7068232727710477 -1.61057157542846e-07 -0.09984001650467106 +2.3468 0.7068246339829107 0.7068233599167528 -1.6103563479051564e-07 -0.09984006506581435 +2.3469 0.7068247185699874 0.7068234470358319 -1.6098692129026815e-07 -0.09984011361222923 +2.347 0.7068248031318753 0.7068235341280014 -1.6091103650049676e-07 -0.09984016214392023 +2.3470999999999997 0.7068248876688741 0.7068236211929775 -1.608080061367423e-07 -0.09984021066089177 +2.3472000000000004 0.706824972181282 0.7068237082304771 -1.6067786216128477e-07 -0.09984025916314831 +2.3473 0.7068250566693983 0.7068237952402173 -1.605206427848782e-07 -0.0998403076506943 +2.3474 0.7068251411335208 0.7068238822219158 -1.6033639245113807e-07 -0.0998403561235342 +2.3475 0.7068252255739469 0.7068239691752908 -1.6012516181398984e-07 -0.0998404045816724 +2.3476 0.7068253099909738 0.706824056100061 -1.5988700775154685e-07 -0.09984045302511345 +2.3477 0.7068253943848978 0.7068241429959463 -1.5962199330366023e-07 -0.09984050145386177 +2.3478000000000003 0.7068254787560141 0.7068242298626666 -1.5933018771355223e-07 -0.09984054986792179 +2.3479 0.7068255631046173 0.7068243166999433 -1.5901166636189679e-07 -0.09984059826729796 +2.348 0.7068256474310014 0.7068244035074982 -1.5866651077896254e-07 -0.09984064665199471 +2.3481 0.7068257317354592 0.7068244902850543 -1.5829480860471423e-07 -0.09984069502201656 +2.3482000000000003 0.7068258160182823 0.7068245770323356 -1.578966535766696e-07 -0.09984074337736787 +2.3483 0.7068259002797617 0.7068246637490672 -1.574721454986744e-07 -0.09984079171805316 +2.3484000000000003 0.7068259845201864 0.7068247504349751 -1.5702139022182038e-07 -0.09984084004407677 +2.3485 0.7068260687398452 0.7068248370897867 -1.5654449962709815e-07 -0.09984088835544323 +2.3486 0.7068261529390252 0.7068249237132307 -1.560415915733554e-07 -0.09984093665215693 +2.3487000000000005 0.7068262371180118 0.7068250103050369 -1.55512789890358e-07 -0.09984098493422232 +2.3488 0.7068263212770897 0.706825096864937 -1.5495822434929973e-07 -0.09984103320164384 +2.3489 0.7068264054165413 0.7068251833926638 -1.543780306107606e-07 -0.09984108145442593 +2.349 0.7068264895366483 0.7068252698879517 -1.5377235020042068e-07 -0.09984112969257301 +2.3491 0.7068265736376902 0.7068253563505364 -1.5314133048303924e-07 -0.09984117791608951 +2.3492 0.7068266577199452 0.7068254427801558 -1.524851246346992e-07 -0.09984122612497988 +2.3493000000000004 0.7068267417836896 0.7068255291765492 -1.5180389157515295e-07 -0.09984127431924855 +2.3494 0.706826825829198 0.7068256155394574 -1.510977959487403e-07 -0.09984132249889989 +2.3495 0.7068269098567429 0.7068257018686238 -1.503670080931635e-07 -0.09984137066393839 +2.3495999999999997 0.7068269938665954 0.7068257881637932 -1.4961170397530255e-07 -0.09984141881436848 +2.3497000000000003 0.7068270778590242 0.7068258744247121 -1.4883206518254144e-07 -0.09984146695019451 +2.3498 0.7068271618342961 0.7068259606511296 -1.4802827882735847e-07 -0.09984151507142099 +2.3499 0.706827245792676 0.7068260468427965 -1.4720053755946927e-07 -0.09984156317805229 +2.35 0.7068273297344264 0.706826132999466 -1.4634903948082534e-07 -0.09984161127009286 +2.3501 0.7068274136598078 0.7068262191208928 -1.4547398812306267e-07 -0.09984165934754707 +2.3502 0.7068274975690783 0.7068263052068349 -1.4457559237464335e-07 -0.09984170741041937 +2.3503000000000003 0.706827581462494 0.7068263912570519 -1.4365406644616108e-07 -0.09984175545871421 +2.3504 0.706827665340308 0.7068264772713062 -1.4270962982350366e-07 -0.09984180349243596 +2.3505 0.7068277492027715 0.7068265632493619 -1.417425072036682e-07 -0.09984185151158902 +2.3506 0.7068278330501332 0.7068266491909863 -1.407529284513931e-07 -0.09984189951617782 +2.3507000000000002 0.7068279168826389 0.7068267350959488 -1.3974112853150367e-07 -0.09984194750620676 +2.3508 0.7068280007005322 0.7068268209640219 -1.3870734747074842e-07 -0.09984199548168027 +2.3509 0.7068280845040542 0.7068269067949804 -1.3765183028494055e-07 -0.0998420434426028 +2.351 0.7068281682934425 0.706826992588601 -1.3657482693558987e-07 -0.09984209138897862 +2.3510999999999997 0.7068282520689328 0.7068270783446647 -1.35476592253575e-07 -0.09984213932081226 +2.3512000000000004 0.7068283358307579 0.7068271640629544 -1.3435738588710167e-07 -0.09984218723810809 +2.3513 0.706828419579147 0.7068272497432558 -1.3321747225486513e-07 -0.09984223514087051 +2.3514 0.7068285033143273 0.7068273353853578 -1.320571204558446e-07 -0.09984228302910392 +2.3515 0.7068285870365224 0.7068274209890519 -1.3087660424154768e-07 -0.09984233090281269 +2.3516 0.7068286707459533 0.7068275065541328 -1.2967620190325324e-07 -0.09984237876200125 +2.3517 0.706828754442838 0.7068275920803986 -1.2845619625119487e-07 -0.09984242660667399 +2.3518000000000003 0.7068288381273911 0.7068276775676496 -1.272168745208857e-07 -0.09984247443683533 +2.3519 0.7068289217998244 0.7068277630156902 -1.2595852831934207e-07 -0.09984252225248963 +2.352 0.7068290054603459 0.7068278484243272 -1.2468145355395976e-07 -0.09984257005364129 +2.3521 0.7068290891091611 0.7068279337933714 -1.2338595035965572e-07 -0.09984261784029472 +2.3522000000000003 0.7068291727464717 0.7068280191226362 -1.220723230277443e-07 -0.0998426656124543 +2.3523 0.7068292563724765 0.7068281044119384 -1.2074087994348726e-07 -0.09984271337012446 +2.3524000000000003 0.7068293399873704 0.7068281896610984 -1.1939193349935762e-07 -0.09984276111330948 +2.3525 0.7068294235913457 0.7068282748699402 -1.1802580002912011e-07 -0.09984280884201384 +2.3526 0.7068295071845903 0.7068283600382905 -1.16642799740177e-07 -0.09984285655624188 +2.3527000000000005 0.7068295907672892 0.7068284451659805 -1.1524325662509716e-07 -0.099842904255998 +2.3528000000000002 0.7068296743396236 0.7068285302528439 -1.1382749840437023e-07 -0.09984295194128655 +2.3529 0.7068297579017717 0.7068286152987187 -1.1239585642405792e-07 -0.09984299961211197 +2.353 0.7068298414539071 0.7068287003034461 -1.1094866560201755e-07 -0.09984304726847859 +2.3531 0.706829924996201 0.7068287852668713 -1.0948626433596176e-07 -0.09984309491039084 +2.3532 0.7068300085288199 0.7068288701888428 -1.0800899442539591e-07 -0.09984314253785309 +2.3533000000000004 0.7068300920519268 0.7068289550692128 -1.0651720100916806e-07 -0.09984319015086968 +2.3534 0.7068301755656814 0.7068290399078377 -1.0501123245618138e-07 -0.09984323774944501 +2.3535 0.7068302590702392 0.7068291247045773 -1.0349144030554619e-07 -0.09984328533358346 +2.3535999999999997 0.7068303425657518 0.7068292094592951 -1.0195817917463962e-07 -0.09984333290328934 +2.3537000000000003 0.7068304260523672 0.7068292941718588 -1.0041180668191041e-07 -0.09984338045856711 +2.3538 0.7068305095302296 0.7068293788421397 -9.88526833566733e-08 -0.09984342799942104 +2.3539 0.7068305929994791 0.7068294634700132 -9.728117256711799e-08 -0.0998434755258556 +2.354 0.7068306764602519 0.7068295480553586 -9.569764041709311e-08 -0.0998435230378751 +2.3541 0.7068307599126803 0.7068296325980588 -9.410245568365616e-08 -0.09984357053548387 +2.3542 0.7068308433568926 0.7068297170980012 -9.249598971038803e-08 -0.09984361801868635 +2.3543000000000003 0.706830926793013 0.7068298015550774 -9.08786163319325e-08 -0.0998436654874869 +2.3544 0.7068310102211615 0.7068298859691817 -8.925071178726013e-08 -0.09984371294188982 +2.3545 0.7068310936414546 0.7068299703402143 -8.761265462946255e-08 -0.09984376038189952 +2.3546 0.7068311770540039 0.7068300546680784 -8.596482563728164e-08 -0.09984380780752034 +2.3547000000000002 0.7068312604589175 0.7068301389526812 -8.430760772490387e-08 -0.0998438552187566 +2.3548 0.7068313438562994 0.7068302231939348 -8.264138586303038e-08 -0.09984390261561277 +2.3549 0.7068314272462488 0.7068303073917548 -8.096654697392625e-08 -0.09984394999809304 +2.355 0.7068315106288614 0.7068303915460612 -7.928347985595996e-08 -0.09984399736620193 +2.3550999999999997 0.706831594004228 0.7068304756567781 -7.759257508385686e-08 -0.09984404471994367 +2.3552000000000004 0.7068316773724362 0.706830559723834 -7.589422492543241e-08 -0.09984409205932267 +2.3553 0.7068317607335685 0.7068306437471616 -7.41888232409782e-08 -0.09984413938434328 +2.3554 0.7068318440877033 0.7068307277266976 -7.247676540259734e-08 -0.09984418669500977 +2.3555 0.7068319274349149 0.7068308116623834 -7.075844819315683e-08 -0.0998442339913266 +2.3556 0.7068320107752735 0.7068308955541643 -6.903426972388813e-08 -0.09984428127329811 +2.3557 0.7068320941088446 0.70683097940199 -6.730462933464063e-08 -0.09984432854092858 +2.3558000000000003 0.7068321774356896 0.7068310632058146 -6.556992750454335e-08 -0.0998443757942224 +2.3559 0.7068322607558652 0.706831146965596 -6.383056575789622e-08 -0.0998444230331838 +2.356 0.7068323440694249 0.7068312306812972 -6.208694657353075e-08 -0.09984447025781724 +2.3561 0.7068324273764164 0.7068313143528853 -6.033947328983394e-08 -0.09984451746812706 +2.3562000000000003 0.706832510676884 0.7068313979803311 -5.8588550009338464e-08 -0.09984456466411751 +2.3563 0.7068325939708675 0.7068314815636108 -5.6834581513287574e-08 -0.09984461184579302 +2.3564000000000003 0.706832677258402 0.706831565102704 -5.507797315863587e-08 -0.09984465901315784 +2.3565 0.706832760539519 0.7068316485975953 -5.331913079152997e-08 -0.09984470616621638 +2.3566 0.7068328438142446 0.7068317320482732 -5.155846064561036e-08 -0.09984475330497294 +2.3567000000000005 0.7068329270826013 0.7068318154547311 -4.979636925852779e-08 -0.09984480042943183 +2.3568000000000002 0.7068330103446068 0.706831898816966 -4.80332633699199e-08 -0.09984484753959738 +2.3569 0.7068330936002749 0.7068319821349802 -4.6269549832777656e-08 -0.099844894635474 +2.357 0.7068331768496146 0.7068320654087796 -4.450563551375297e-08 -0.09984494171706594 +2.3571 0.7068332600926304 0.7068321486383751 -4.2741927205284126e-08 -0.09984498878437756 +2.3572 0.706833343329323 0.706832231823781 -4.097883152969807e-08 -0.09984503583741314 +2.3573000000000004 0.7068334265596885 0.7068323149650173 -3.92167548435296e-08 -0.09984508287617705 +2.3574 0.7068335097837182 0.706832398062107 -3.745610314704467e-08 -0.09984512990067357 +2.3575 0.7068335930013998 0.7068324811150781 -3.569728198736695e-08 -0.09984517691090705 +2.3575999999999997 0.7068336762127161 0.7068325641239634 -3.3940696369302165e-08 -0.09984522390688179 +2.3577000000000004 0.7068337594176457 0.7068326470887996 -3.218675065754309e-08 -0.09984527088860215 +2.3578 0.7068338426161629 0.7068327300096271 -3.0435848487331274e-08 -0.09984531785607241 +2.3579 0.7068339258082378 0.7068328128864916 -2.8688392670348298e-08 -0.0998453648092969 +2.358 0.7068340089938356 0.706832895719443 -2.694478509930598e-08 -0.09984541174827993 +2.3581 0.7068340921729183 0.7068329785085348 -2.5205426662511243e-08 -0.0998454586730258 +2.3582 0.7068341753454425 0.7068330612538253 -2.347071714281848e-08 -0.09984550558353886 +2.3583000000000003 0.706834258511361 0.706833143955377 -2.17410551337123e-08 -0.09984555247982334 +2.3584 0.7068343416706222 0.7068332266132571 -2.001683794194617e-08 -0.09984559936188367 +2.3585 0.7068344248231707 0.7068333092275358 -1.829846149863784e-08 -0.09984564622972406 +2.3586 0.7068345079689462 0.7068333917982891 -1.6586320270798455e-08 -0.09984569308334884 +2.3587000000000002 0.7068345911078844 0.706833474325596 -1.488080716895851e-08 -0.09984573992276227 +2.3588 0.706834674239917 0.7068335568095403 -1.3182313450890715e-08 -0.09984578674796873 +2.3589 0.7068347573649716 0.7068336392502096 -1.1491228644848472e-08 -0.09984583355897247 +2.359 0.7068348404829712 0.7068337216476962 -9.807940445916152e-09 -0.09984588035577784 +2.3590999999999998 0.7068349235938352 0.7068338040020963 -8.132834642717024e-09 -0.0998459271383891 +2.3592000000000004 0.7068350066974782 0.7068338863135101 -6.466295012462486e-09 -0.09984597390681062 +2.3593 0.7068350897938112 0.706833968582042 -4.808703245491597e-09 -0.09984602066104664 +2.3594 0.7068351728827412 0.7068340508077999 -3.1604388489939184e-09 -0.09984606740110147 +2.3595 0.7068352559641708 0.7068341329908969 -1.5218790750184952e-09 -0.09984611412697937 +2.3596 0.7068353390379987 0.7068342151314488 1.0660119228317333e-10 -0.09984616083868464 +2.3597 0.7068354221041198 0.7068342972295767 1.724629491300922e-09 -0.09984620753622162 +2.3598000000000003 0.7068355051624244 0.7068343792854048 3.3318358887840516e-09 -0.09984625421959453 +2.3599 0.7068355882127999 0.7068344612990616 4.927853057903886e-09 -0.09984630088880775 +2.36 0.7068356712551287 0.7068345432706791 6.512316364989945e-09 -0.0998463475438655 +2.3601 0.7068357542892902 0.7068346252003936 8.084863950194587e-09 -0.09984639418477208 +2.3602000000000003 0.7068358373151595 0.7068347070883452 9.645136806422927e-09 -0.09984644081153181 +2.3603 0.706835920332608 0.7068347889346775 1.1192778873875264e-08 -0.09984648742414895 +2.3604000000000003 0.706836003341503 0.7068348707395383 1.2727437105966577e-08 -0.09984653402262778 +2.3605 0.7068360863417085 0.7068349525030787 1.4248761560399503e-08 -0.09984658060697253 +2.3606 0.7068361693330845 0.7068350342254542 1.5756405469420642e-08 -0.09984662717718758 +2.3607000000000005 0.7068362523154874 0.7068351159068232 1.7250025330893537e-08 -0.09984667373327714 +2.3608000000000002 0.7068363352887703 0.7068351975473484 1.8729280975085527e-08 -0.09984672027524555 +2.3609 0.7068364182527818 0.7068352791471955 2.0193835655740733e-08 -0.09984676680309701 +2.361 0.7068365012073674 0.7068353607065341 2.1643356109928014e-08 -0.09984681331683581 +2.3611 0.7068365841523696 0.7068354422255376 2.3077512647379228e-08 -0.0998468598164663 +2.3612 0.7068366670876267 0.7068355237043824 2.4495979212071917e-08 -0.09984690630199262 +2.3613000000000004 0.7068367500129737 0.7068356051432485 2.5898433472434923e-08 -0.09984695277341918 +2.3614 0.7068368329282425 0.7068356865423195 2.72845568846658e-08 -0.09984699923075019 +2.3615 0.7068369158332612 0.7068357679017823 2.8654034768191283e-08 -0.09984704567398989 +2.3615999999999997 0.7068369987278548 0.706835849221827 3.000655636811733e-08 -0.09984709210314262 +2.3617000000000004 0.7068370816118448 0.7068359305026468 3.134181495237365e-08 -0.09984713851821256 +2.3618 0.7068371644850497 0.7068360117444388 3.2659507832530354e-08 -0.09984718491920405 +2.3619 0.7068372473472849 0.7068360929474027 3.3959336486963365e-08 -0.09984723130612133 +2.362 0.7068373301983621 0.7068361741117415 3.524100659381413e-08 -0.09984727767896862 +2.3621 0.7068374130380904 0.7068362552376615 3.650422811078691e-08 -0.09984732403775022 +2.3622 0.7068374958662754 0.7068363363253718 3.774871533065993e-08 -0.09984737038247037 +2.3623000000000003 0.7068375786827203 0.7068364173750846 3.897418696108268e-08 -0.09984741671313332 +2.3624 0.7068376614872249 0.706836498387015 4.018036617314813e-08 -0.09984746302974334 +2.3625 0.7068377442795863 0.7068365793613813 4.1366980675985876e-08 -0.09984750933230473 +2.3626 0.7068378270595985 0.7068366602984043 4.2533762761864935e-08 -0.09984755562082166 +2.3627000000000002 0.7068379098270527 0.7068367411983081 4.36804493911952e-08 -0.0998476018952985 +2.3628 0.7068379925817377 0.7068368220613188 4.4806782220283004e-08 -0.0998476481557394 +2.3629000000000002 0.7068380753234389 0.706836902887666 4.591250770021038e-08 -0.09984769440214863 +2.363 0.7068381580519396 0.7068369836775815 4.6997377087243386e-08 -0.0998477406345305 +2.3630999999999998 0.7068382407670204 0.7068370644312998 4.806114653650717e-08 -0.09984778685288921 +2.3632000000000004 0.7068383234684593 0.706837145149058 4.9103577131476284e-08 -0.09984783305722904 +2.3633 0.7068384061560318 0.7068372258310957 5.012443497071084e-08 -0.09984787924755419 +2.3634 0.7068384888295105 0.7068373064776549 5.112349116265236e-08 -0.09984792542386892 +2.3635 0.7068385714886662 0.70683738708898 5.2100521940115496e-08 -0.09984797158617748 +2.3636 0.7068386541332672 0.7068374676653177 5.3055308672431134e-08 -0.09984801773448404 +2.3637 0.7068387367630793 0.7068375482069171 5.398763792269223e-08 -0.09984806386879293 +2.3638000000000003 0.7068388193778665 0.7068376287140297 5.4897301498060824e-08 -0.09984810998910837 +2.3639 0.7068389019773906 0.7068377091869085 5.578409650701388e-08 -0.09984815609543463 +2.364 0.7068389845614109 0.7068377896258091 5.664782536454749e-08 -0.09984820218777588 +2.3641 0.7068390671296843 0.7068378700309894 5.748829590319915e-08 -0.09984824826613636 +2.3642000000000003 0.7068391496819668 0.7068379504027089 5.8305321340088034e-08 -0.09984829433052039 +2.3643 0.7068392322180115 0.706838030741229 5.909872037059005e-08 -0.09984834038093211 +2.3644000000000003 0.7068393147375702 0.7068381110468132 5.98683171943587e-08 -0.0998483864173758 +2.3645 0.7068393972403927 0.7068381913197266 6.061394155695843e-08 -0.09984843243985567 +2.3646 0.7068394797262267 0.7068382715602365 6.13354287620077e-08 -0.09984847844837597 +2.3647000000000005 0.7068395621948189 0.7068383517686111 6.203261975618046e-08 -0.0998485244429409 +2.3648000000000002 0.7068396446459136 0.7068384319451211 6.270536111185887e-08 -0.09984857042355469 +2.3649 0.7068397270792541 0.706838512090038 6.335350510693061e-08 -0.09984861639022158 +2.365 0.7068398094945818 0.7068385922036355 6.397690972652359e-08 -0.09984866234294579 +2.3651 0.706839891891637 0.7068386722861886 6.457543869943516e-08 -0.09984870828173155 +2.3652 0.7068399742701583 0.7068387523379731 6.514896154150018e-08 -0.09984875420658311 +2.3653000000000004 0.7068400566298829 0.7068388323592668 6.569735356426465e-08 -0.09984880011750459 +2.3654 0.7068401389705473 0.7068389123503485 6.622049591141488e-08 -0.09984884601450028 +2.3655 0.7068402212918862 0.7068389923114982 6.671827559520671e-08 -0.0998488918975744 +2.3655999999999997 0.7068403035936333 0.7068390722429969 6.71905854964655e-08 -0.09984893776673115 +2.3657000000000004 0.7068403858755212 0.7068391521451274 6.763732441662784e-08 -0.09984898362197475 +2.3658 0.706840468137282 0.7068392320181726 6.805839707427208e-08 -0.09984902946330945 +2.3659 0.7068405503786459 0.7068393118624166 6.845371413634338e-08 -0.09984907529073941 +2.366 0.7068406325993432 0.7068393916781444 6.88231922407051e-08 -0.09984912110426887 +2.3661 0.7068407147991023 0.7068394714656421 6.916675399960825e-08 -0.09984916690390198 +2.3662 0.7068407969776521 0.7068395512251966 6.948432803438598e-08 -0.09984921268964306 +2.3663000000000003 0.7068408791347197 0.7068396309570946 6.97758489737188e-08 -0.09984925846149617 +2.3664 0.7068409612700322 0.7068397106616247 7.004125747098189e-08 -0.09984930421946564 +2.3665 0.7068410433833159 0.7068397903390753 7.028050023026589e-08 -0.09984934996355568 +2.3666 0.7068411254742968 0.7068398699897352 7.049352999943803e-08 -0.09984939569377042 +2.3667000000000002 0.7068412075427 0.706839949613894 7.068030557708105e-08 -0.09984944141011406 +2.3668 0.7068412895882508 0.7068400292118413 7.084079184545289e-08 -0.09984948711259084 +2.3669000000000002 0.7068413716106736 0.7068401087838676 7.097495973926171e-08 -0.09984953280120494 +2.367 0.7068414536096939 0.7068401883302632 7.108278628729925e-08 -0.09984957847596061 +2.3670999999999998 0.7068415355850348 0.7068402678513184 7.116425459162412e-08 -0.09984962413686199 +2.3672000000000004 0.7068416175364214 0.706840347347324 7.121935383450073e-08 -0.09984966978391331 +2.3673 0.7068416994635777 0.7068404268185706 7.124807928707289e-08 -0.09984971541711876 +2.3674 0.7068417813662276 0.7068405062653489 7.125043230762906e-08 -0.09984976103648252 +2.3675 0.7068418632440955 0.7068405856879492 7.122642032252047e-08 -0.09984980664200876 +2.3676 0.7068419450969059 0.7068406650866621 7.117605685565132e-08 -0.09984985223370169 +2.3677 0.7068420269243836 0.7068407444617779 7.109936147470242e-08 -0.09984989781156552 +2.3678000000000003 0.7068421087262535 0.7068408238135864 7.099635983970343e-08 -0.09984994337560445 +2.3679 0.7068421905022408 0.7068409031423766 7.086708365966476e-08 -0.09984998892582257 +2.368 0.7068422722520711 0.7068409824484383 7.071157068563871e-08 -0.09985003446222417 +2.3681 0.7068423539754709 0.7068410617320597 7.052986470724998e-08 -0.09985007998481338 +2.3682000000000003 0.7068424356721669 0.7068411409935292 7.032201555096096e-08 -0.09985012549359441 +2.3683 0.7068425173418862 0.7068412202331343 7.008807905231618e-08 -0.09985017098857148 +2.3684000000000003 0.706842598984357 0.7068412994511616 6.98281170507381e-08 -0.0998502164697487 +2.3685 0.7068426805993078 0.7068413786478971 6.954219736003686e-08 -0.09985026193713027 +2.3686 0.7068427621864686 0.7068414578236262 6.923039375800188e-08 -0.0998503073907204 +2.3687000000000005 0.7068428437455693 0.7068415369786332 6.889278597599358e-08 -0.09985035283052321 +2.3688000000000002 0.7068429252763415 0.7068416161132015 6.852945965904467e-08 -0.09985039825654293 +2.3689 0.7068430067785176 0.7068416952276135 6.814050637453384e-08 -0.0998504436687837 +2.369 0.7068430882518308 0.7068417743221507 6.772602355493984e-08 -0.09985048906724966 +2.3691 0.7068431696960159 0.7068418533970935 6.728611450131095e-08 -0.09985053445194508 +2.3692 0.7068432511108083 0.7068419324527208 6.682088834163158e-08 -0.09985057982287406 +2.3693 0.7068433324959449 0.7068420114893106 6.633046001694454e-08 -0.09985062518004081 +2.3694 0.7068434138511641 0.7068420905071393 6.581495021890094e-08 -0.09985067052344948 +2.3695 0.7068434951762055 0.7068421695064822 6.527448542965886e-08 -0.09985071585310425 +2.3695999999999997 0.7068435764708099 0.7068422484876128 6.470919780565687e-08 -0.09985076116900925 +2.3697000000000004 0.7068436577347199 0.7068423274508036 6.411922521404323e-08 -0.09985080647116866 +2.3698 0.7068437389676796 0.706842406396325 6.350471115634804e-08 -0.0998508517595866 +2.3699 0.7068438201694348 0.706842485324446 6.286580476327908e-08 -0.0998508970342673 +2.37 0.7068439013397325 0.7068425642354346 6.220266073227176e-08 -0.09985094229521492 +2.3701 0.7068439824783223 0.7068426431295562 6.151543931014192e-08 -0.09985098754243363 +2.3702 0.7068440635849544 0.7068427220070744 6.080430624971767e-08 -0.09985103277592752 +2.3703000000000003 0.7068441446593821 0.7068428008682515 6.00694327612672e-08 -0.09985107799570081 +2.3704 0.7068442257013594 0.7068428797133475 5.931099548474317e-08 -0.0998511232017576 +2.3705 0.7068443067106434 0.7068429585426206 5.852917642906741e-08 -0.09985116839410213 +2.3706 0.7068443876869922 0.7068430373563267 5.7724162954783664e-08 -0.09985121357273843 +2.3707000000000003 0.7068444686301667 0.7068431161547201 5.6896147694260324e-08 -0.09985125873767074 +2.3708 0.7068445495399298 0.7068431949380527 5.604532854648625e-08 -0.09985130388890318 +2.3709000000000002 0.7068446304160461 0.7068432737065742 5.51719085972735e-08 -0.09985134902643991 +2.371 0.7068447112582832 0.7068433524605322 5.42760960880323e-08 -0.09985139415028509 +2.3710999999999998 0.7068447920664103 0.7068434312001717 5.3358104355055724e-08 -0.09985143926044282 +2.3712000000000004 0.7068448728401994 0.7068435099257355 5.241815179135578e-08 -0.09985148435691732 +2.3713 0.706844953579425 0.706843588637464 5.145646177553975e-08 -0.09985152943971269 +2.3714 0.7068450342838634 0.7068436673355952 5.0473262652728224e-08 -0.09985157450883303 +2.3715 0.7068451149532942 0.7068437460203646 4.9468787628736965e-08 -0.09985161956428257 +2.3716 0.7068451955874988 0.7068438246920051 4.844327477701582e-08 -0.0998516646060654 +2.3717 0.7068452761862619 0.7068439033507468 4.7396966932830575e-08 -0.09985170963418565 +2.3718000000000004 0.7068453567493707 0.7068439819968172 4.633011164989487e-08 -0.09985175464864748 +2.3719 0.7068454372766146 0.7068440606304414 4.524296115353266e-08 -0.09985179964945506 +2.372 0.7068455177677865 0.7068441392518413 4.413577226955456e-08 -0.09985184463661244 +2.3721 0.7068455982226818 0.7068442178612363 4.3008806365277263e-08 -0.09985188961012384 +2.3722000000000003 0.7068456786410984 0.7068442964588426 4.186232929574707e-08 -0.09985193456999333 +2.3723 0.7068457590228376 0.7068443750448741 4.069661133608571e-08 -0.0998519795162251 +2.3724000000000003 0.7068458393677035 0.706844453619541 3.9511927096488875e-08 -0.09985202444882324 +2.3725 0.7068459196755033 0.7068445321830509 3.830855550140955e-08 -0.0998520693677919 +2.3726 0.7068459999460468 0.7068446107356083 3.7086779687209304e-08 -0.09985211427313517 +2.3727000000000005 0.7068460801791476 0.7068446892774148 3.584688695011662e-08 -0.09985215916485723 +2.3728000000000002 0.7068461603746217 0.7068447678086682 3.458916868551154e-08 -0.09985220404296215 +2.3729 0.7068462405322891 0.706844846329564 3.331392029945479e-08 -0.09985224890745412 +2.373 0.7068463206519721 0.7068449248402935 3.202144116358496e-08 -0.0998522937583372 +2.3731 0.7068464007334968 0.7068450033410458 3.071203451970872e-08 -0.0998523385956155 +2.3732 0.7068464807766928 0.7068450818320062 2.938600742428965e-08 -0.09985238341929324 +2.3733 0.7068465607813923 0.7068451603133563 2.8043670677324606e-08 -0.09985242822937446 +2.3734 0.7068466407474319 0.7068452387852749 2.668533874428114e-08 -0.09985247302586331 +2.3735 0.7068467206746507 0.706845317247937 2.531132968497385e-08 -0.09985251780876389 +2.3735999999999997 0.7068468005628916 0.7068453957015141 2.3921965075501817e-08 -0.0998525625780803 +2.3737000000000004 0.7068468804120014 0.7068454741461745 2.2517569940594395e-08 -0.09985260733381672 +2.3738 0.7068469602218297 0.7068455525820829 2.1098472667742396e-08 -0.09985265207597721 +2.3739 0.7068470399922298 0.7068456310094002 1.9665004940411235e-08 -0.09985269680456582 +2.374 0.7068471197230592 0.7068457094282841 1.821750164696795e-08 -0.0998527415195868 +2.3741 0.7068471994141783 0.7068457878388881 1.675630081736379e-08 -0.09985278622104414 +2.3742 0.7068472790654518 0.7068458662413625 1.528174353639805e-08 -0.09985283090894198 +2.3743000000000003 0.7068473586767478 0.7068459446358538 1.3794173865655512e-08 -0.09985287558328451 +2.3744 0.7068474382479378 0.7068460230225047 1.2293938763709156e-08 -0.09985292024407573 +2.3745 0.706847517778898 0.706846101401454 1.078138800632289e-08 -0.09985296489131984 +2.3746 0.7068475972695072 0.706846179772837 9.256874098848011e-09 -0.09985300952502085 +2.3747000000000003 0.7068476767196488 0.7068462581367849 7.720752207701631e-09 -0.0998530541451829 +2.3748 0.7068477561292099 0.7068463364934253 6.1733800554159e-09 -0.09985309875181012 +2.3749000000000002 0.7068478354980814 0.7068464148428817 4.615117861657414e-09 -0.09985314334490658 +2.375 0.7068479148261579 0.7068464931852736 3.0463282443479733e-09 -0.09985318792447632 +2.3750999999999998 0.7068479941133383 0.7068465715207173 1.4673761363978577e-09 -0.09985323249052352 +2.3752000000000004 0.7068480733595253 0.7068466498493242 -1.2137128801992247e-10 -0.09985327704305225 +2.3753 0.7068481525646255 0.7068467281712024 -1.7195447132162256e-09 -0.09985332158206661 +2.3754 0.7068482317285496 0.7068468064864557 -3.326772761783059e-09 -0.09985336610757072 +2.3755 0.706848310851212 0.7068468847951839 -4.942682081329752e-09 -0.0998534106195686 +2.3756 0.7068483899325315 0.706846963097483 -6.566897428617047e-09 -0.0998534551180644 +2.3757 0.706848468972431 0.7068470413934445 -8.199041754558545e-09 -0.09985349960306221 +2.3758000000000004 0.7068485479708372 0.7068471196831562 -9.838736300497863e-09 -0.09985354407456609 +2.3759 0.7068486269276808 0.7068471979667017 -1.1485600679740637e-08 -0.09985358853258014 +2.376 0.7068487058428967 0.7068472762441604 -1.3139252970362225e-08 -0.0998536329771084 +2.3761 0.7068487847164244 0.7068473545156078 -1.4799309792402904e-08 -0.09985367740815504 +2.3762000000000003 0.7068488635482069 0.706847432781115 -1.646538641802281e-08 -0.09985372182572408 +2.3763 0.7068489423381912 0.7068475110407494 -1.8137096834385663e-08 -0.09985376622981962 +2.3764000000000003 0.7068490210863294 0.7068475892945736 -1.9814053855114755e-08 -0.09985381062044574 +2.3765 0.706849099792577 0.7068476675426466 -2.1495869195753414e-08 -0.09985385499760657 +2.3766 0.706849178456894 0.7068477457850227 -2.318215357264425e-08 -0.09985389936130612 +2.3767000000000005 0.7068492570792442 0.7068478240217525 -2.487251678576219e-08 -0.09985394371154849 +2.3768000000000002 0.706849335659596 0.7068479022528821 -2.6566567816726366e-08 -0.09985398804833778 +2.3769 0.7068494141979219 0.7068479804784533 -2.8263914911199478e-08 -0.09985403237167803 +2.377 0.7068494926941986 0.706848058698504 -2.996416567451442e-08 -0.09985407668157331 +2.3771 0.7068495711484069 0.7068481369130676 -3.166692716231358e-08 -0.09985412097802772 +2.3772 0.706849649560532 0.7068482151221734 -3.337180596836922e-08 -0.0998541652610453 +2.3773 0.7068497279305633 0.7068482933258466 -3.507840831695752e-08 -0.09985420953063019 +2.3774 0.7068498062584944 0.7068483715241081 -3.6786340155557824e-08 -0.09985425378678639 +2.3775 0.7068498845443227 0.706848449716974 -3.8495207243215146e-08 -0.09985429802951795 +2.3775999999999997 0.7068499627880509 0.7068485279044571 -4.020461524264314e-08 -0.09985434225882897 +2.3777000000000004 0.706850040989685 0.7068486060865654 -4.191416981080918e-08 -0.09985438647472356 +2.3778 0.7068501191492353 0.7068486842633026 -4.36234766902242e-08 -0.09985443067720572 +2.3779 0.7068501972667167 0.7068487624346685 -4.5332141800286715e-08 -0.09985447486627948 +2.378 0.7068502753421482 0.7068488406006588 -4.7039771326892136e-08 -0.09985451904194902 +2.3781 0.706850353375553 0.7068489187612641 -4.874597181437311e-08 -0.0998545632042183 +2.3782 0.7068504313669587 0.7068489969164717 -5.045035025429568e-08 -0.09985460735309146 +2.3783000000000003 0.7068505093163964 0.7068490750662643 -5.215251417745384e-08 -0.09985465148857242 +2.3784 0.7068505872239024 0.7068491532106205 -5.38520717459183e-08 -0.09985469561066539 +2.3785 0.7068506650895167 0.7068492313495146 -5.554863183928477e-08 -0.09985473971937438 +2.3786 0.7068507429132832 0.7068493094829165 -5.724180414650587e-08 -0.09985478381470338 +2.3787000000000003 0.7068508206952505 0.7068493876107924 -5.893119925793992e-08 -0.0998548278966565 +2.3788 0.7068508984354713 0.7068494657331041 -6.061642874970186e-08 -0.09985487196523779 +2.3789000000000002 0.7068509761340022 0.7068495438498092 -6.229710527820564e-08 -0.09985491602045132 +2.379 0.706851053790904 0.7068496219608611 -6.397284266516576e-08 -0.0998549600623011 +2.3790999999999998 0.7068511314062416 0.7068497000662093 -6.564325598888698e-08 -0.09985500409079116 +2.3792000000000004 0.7068512089800842 0.7068497781657987 -6.730796167121744e-08 -0.09985504810592559 +2.3793 0.7068512865125051 0.7068498562595711 -6.89665775677542e-08 -0.09985509210770846 +2.3794 0.7068513640035814 0.7068499343474629 -7.061872305197739e-08 -0.09985513609614376 +2.3795 0.7068514414533944 0.7068500124294073 -7.226401910588945e-08 -0.09985518007123553 +2.3796 0.7068515188620299 0.706850090505333 -7.39020884037156e-08 -0.09985522403298784 +2.3797 0.7068515962295768 0.7068501685751649 -7.553255540124204e-08 -0.09985526798140466 +2.3798000000000004 0.7068516735561289 0.7068502466388243 -7.715504642298587e-08 -0.09985531191649016 +2.3799 0.7068517508417835 0.7068503246962278 -7.87691897402576e-08 -0.09985535583824828 +2.38 0.706851828086642 0.7068504027472882 -8.03746156670046e-08 -0.09985539974668312 +2.3801 0.7068519052908097 0.7068504807919144 -8.197095663613901e-08 -0.0998554436417986 +2.3802000000000003 0.706851982454396 0.7068505588300117 -8.35578472897433e-08 -0.09985548752359892 +2.3803 0.7068520595775135 0.7068506368614811 -8.513492455886756e-08 -0.09985553139208793 +2.3804000000000003 0.7068521366602798 0.70685071488622 -8.670182773985735e-08 -0.09985557524726979 +2.3805 0.7068522137028155 0.7068507929041219 -8.8258198595835e-08 -0.09985561908914857 +2.3806 0.7068522907052455 0.706850870915076 -8.980368141914968e-08 -0.09985566291772817 +2.3807000000000005 0.7068523676676979 0.7068509489189685 -9.13379231241851e-08 -0.0998557067330127 +2.3808000000000002 0.706852444590305 0.7068510269156814 -9.286057331935049e-08 -0.09985575053500619 +2.3809 0.7068525214732029 0.706851104905093 -9.437128440075576e-08 -0.09985579432371261 +2.381 0.7068525983165312 0.7068511828870777 -9.586971161292673e-08 -0.09985583809913605 +2.3811 0.7068526751204329 0.7068512608615066 -9.735551313901081e-08 -0.09985588186128046 +2.3812 0.7068527518850554 0.7068513388282472 -9.882835018664576e-08 -0.09985592561014991 +2.3813 0.7068528286105487 0.7068514167871631 -1.0028788704260355e-07 -0.09985596934574845 +2.3814 0.7068529052970671 0.7068514947381144 -1.0173379117253689e-07 -0.09985601306808001 +2.3815 0.7068529819447682 0.7068515726809577 -1.0316573327909251e-07 -0.09985605677714868 +2.3815999999999997 0.7068530585538133 0.7068516506155461 -1.0458338738604522e-07 -0.09985610047295847 +2.3817000000000004 0.7068531351243665 0.7068517285417295 -1.0598643091289106e-07 -0.09985614415551339 +2.3818 0.7068532116565962 0.706851806459354 -1.0737454474076674e-07 -0.09985618782481742 +2.3819 0.7068532881506735 0.7068518843682623 -1.0874741329658377e-07 -0.09985623148087462 +2.382 0.7068533646067734 0.7068519622682943 -1.1010472461374377e-07 -0.09985627512368901 +2.3821 0.7068534410250735 0.7068520401592856 -1.1144617040846627e-07 -0.09985631875326456 +2.3822 0.7068535174057553 0.7068521180410696 -1.1277144615004508e-07 -0.0998563623696053 +2.3823000000000003 0.7068535937490033 0.7068521959134759 -1.1408025112763509e-07 -0.09985640597271518 +2.3824 0.706853670055005 0.706852273776331 -1.1537228851443704e-07 -0.09985644956259833 +2.3825 0.7068537463239513 0.7068523516294583 -1.1664726544229065e-07 -0.09985649313925861 +2.3826 0.7068538225560361 0.7068524294726782 -1.1790489307973717e-07 -0.09985653670270023 +2.3827000000000003 0.7068538987514565 0.7068525073058078 -1.1914488666150969e-07 -0.09985658025292701 +2.3828 0.7068539749104124 0.7068525851286611 -1.2036696558914706e-07 -0.09985662378994298 +2.3829000000000002 0.7068540510331065 0.7068526629410499 -1.2157085347783148e-07 -0.09985666731375223 +2.383 0.7068541271197449 0.706852740742782 -1.227562782118996e-07 -0.09985671082435871 +2.3830999999999998 0.7068542031705359 0.7068528185336633 -1.2392297202984404e-07 -0.09985675432176641 +2.3832000000000004 0.7068542791856913 0.7068528963134961 -1.250706715624772e-07 -0.0998567978059793 +2.3833 0.7068543551654252 0.7068529740820806 -1.2619911789885085e-07 -0.0998568412770014 +2.3834 0.7068544311099548 0.7068530518392135 -1.2730805665044087e-07 -0.09985688473483674 +2.3835 0.7068545070194996 0.7068531295846898 -1.283972379945153e-07 -0.09985692817948927 +2.3836 0.7068545828942818 0.706853207318301 -1.294664167556664e-07 -0.09985697161096298 +2.3837 0.7068546587345264 0.7068532850398366 -1.305153524370356e-07 -0.09985701502926189 +2.3838000000000004 0.7068547345404612 0.7068533627490834 -1.3154380927582476e-07 -0.09985705843439006 +2.3839 0.7068548103123156 0.7068534404458251 -1.3255155631615445e-07 -0.09985710182635138 +2.384 0.7068548860503217 0.7068535181298441 -1.3353836744028902e-07 -0.09985714520514982 +2.3841 0.7068549617547146 0.7068535958009198 -1.3450402142588247e-07 -0.09985718857078946 +2.3842000000000003 0.706855037425731 0.7068536734588291 -1.3544830198934654e-07 -0.09985723192327421 +2.3843 0.7068551130636103 0.706853751103347 -1.363709978587091e-07 -0.0998572752626081 +2.3844000000000003 0.7068551886685936 0.7068538287342465 -1.3727190279269608e-07 -0.0998573185887951 +2.3845 0.7068552642409247 0.7068539063512974 -1.3815081562930376e-07 -0.09985736190183914 +2.3846 0.7068553397808492 0.7068539839542689 -1.3900754036386131e-07 -0.09985740520174427 +2.3847000000000005 0.7068554152886151 0.7068540615429271 -1.398418861403572e-07 -0.0998574484885145 +2.3848000000000003 0.7068554907644717 0.7068541391170362 -1.4065366733991003e-07 -0.09985749176215372 +2.3849 0.7068555662086706 0.706854216676359 -1.4144270358597277e-07 -0.09985753502266595 +2.385 0.7068556416214654 0.7068542942206559 -1.422088198154564e-07 -0.09985757827005515 +2.3851 0.7068557170031116 0.7068543717496857 -1.4295184630128133e-07 -0.09985762150432531 +2.3852 0.7068557923538659 0.7068544492632054 -1.436716186888065e-07 -0.09985766472548041 +2.3853 0.7068558676739869 0.7068545267609705 -1.4436797803225876e-07 -0.09985770793352439 +2.3854 0.7068559429637353 0.7068546042427345 -1.4504077084677436e-07 -0.09985775112846122 +2.3855 0.7068560182233732 0.7068546817082496 -1.456898491083991e-07 -0.09985779431029496 +2.3855999999999997 0.7068560934531638 0.7068547591572664 -1.4631507032347724e-07 -0.09985783747902945 +2.3857000000000004 0.7068561686533721 0.706854836589534 -1.4691629753212088e-07 -0.09985788063466876 +2.3858 0.7068562438242643 0.7068549140047999 -1.4749339936198647e-07 -0.09985792377721679 +2.3859 0.7068563189661085 0.706854991402811 -1.480462500230706e-07 -0.09985796690667759 +2.386 0.7068563940791732 0.7068550687833117 -1.4857472937189475e-07 -0.09985801002305501 +2.3861 0.7068564691637289 0.7068551461460464 -1.4907872291844426e-07 -0.09985805312635314 +2.3862 0.7068565442200467 0.7068552234907574 -1.4955812184178074e-07 -0.09985809621657583 +2.3863000000000003 0.7068566192483992 0.7068553008171865 -1.5001282304728802e-07 -0.0998581392937271 +2.3864 0.7068566942490596 0.7068553781250744 -1.5044272915279433e-07 -0.09985818235781088 +2.3865 0.7068567692223026 0.7068554554141603 -1.5084774852153204e-07 -0.09985822540883114 +2.3866 0.7068568441684033 0.7068555326841832 -1.5122779529336272e-07 -0.09985826844679187 +2.3867000000000003 0.7068569190876381 0.7068556099348811 -1.5158278938130765e-07 -0.099858311471697 +2.3868 0.7068569939802841 0.7068556871659903 -1.519126565131812e-07 -0.09985835448355049 +2.3869000000000002 0.7068570688466187 0.7068557643772477 -1.5221732821944778e-07 -0.09985839748235624 +2.387 0.7068571436869202 0.7068558415683889 -1.5249674186271212e-07 -0.09985844046811829 +2.3870999999999998 0.7068572185014677 0.7068559187391488 -1.5275084066720956e-07 -0.09985848344084051 +2.3872000000000004 0.7068572932905406 0.7068559958892617 -1.529795736823769e-07 -0.0998585264005269 +2.3873 0.7068573680544192 0.7068560730184621 -1.5318289584703715e-07 -0.0998585693471814 +2.3874 0.7068574427933834 0.7068561501264832 -1.5336076797552167e-07 -0.09985861228080795 +2.3875 0.7068575175077141 0.7068562272130583 -1.535131567351189e-07 -0.09985865520141052 +2.3876 0.7068575921976924 0.7068563042779206 -1.5364003470158538e-07 -0.099858698108993 +2.3877 0.7068576668635994 0.7068563813208026 -1.5374138033485973e-07 -0.09985874100355939 +2.3878000000000004 0.7068577415057167 0.706856458341437 -1.5381717800161399e-07 -0.0998587838851136 +2.3879 0.7068578161243255 0.7068565353395562 -1.538674179457633e-07 -0.09985882675365959 +2.388 0.7068578907197075 0.7068566123148927 -1.5389209631448686e-07 -0.09985886960920132 +2.3881 0.7068579652921441 0.706856689267179 -1.5389121515302362e-07 -0.09985891245174268 +2.3882000000000003 0.7068580398419164 0.7068567661961479 -1.5386478239946821e-07 -0.09985895528128765 +2.3883 0.7068581143693061 0.7068568431015316 -1.538128118830362e-07 -0.09985899809784012 +2.3884000000000003 0.706858188874594 0.7068569199830639 -1.5373532331885986e-07 -0.09985904090140413 +2.3885 0.7068582633580605 0.706856996840477 -1.5363234228890632e-07 -0.09985908369198347 +2.3886 0.7068583378199864 0.7068570736735049 -1.535039002662636e-07 -0.09985912646958219 +2.3887000000000005 0.7068584122606515 0.7068571504818818 -1.5335003457177254e-07 -0.09985916923420417 +2.3888000000000003 0.7068584866803351 0.706857227265342 -1.531707883757616e-07 -0.09985921198585332 +2.3889 0.7068585610793161 0.7068573040236203 -1.5296621069457728e-07 -0.09985925472453361 +2.389 0.7068586354578729 0.7068573807564527 -1.5273635636803284e-07 -0.09985929745024892 +2.3891 0.7068587098162832 0.7068574574635751 -1.5248128605246936e-07 -0.09985934016300325 +2.3892 0.706858784154824 0.7068575341447246 -1.5220106620514318e-07 -0.0998593828628005 +2.3893 0.7068588584737712 0.7068576107996392 -1.518957690425926e-07 -0.09985942554964458 +2.3894 0.7068589327734003 0.706857687428057 -1.5156547256492403e-07 -0.09985946822353939 +2.3895 0.7068590070539857 0.7068577640297176 -1.5121026050030073e-07 -0.09985951088448887 +2.3895999999999997 0.7068590813158007 0.706857840604362 -1.5083022229800402e-07 -0.099859553532497 +2.3897000000000004 0.7068591555591175 0.7068579171517312 -1.5042545311629019e-07 -0.09985959616756762 +2.3898 0.7068592297842077 0.706857993671568 -1.499960537668793e-07 -0.09985963878970469 +2.3899 0.7068593039913413 0.706858070163616 -1.4954213073403722e-07 -0.09985968139891212 +2.39 0.7068593781807873 0.7068581466276203 -1.4906379611386023e-07 -0.09985972399519383 +2.3901 0.7068594523528133 0.7068582230633269 -1.485611675951931e-07 -0.09985976657855371 +2.3902 0.7068595265076857 0.7068582994704835 -1.4803436843881246e-07 -0.09985980914899573 +2.3903000000000003 0.7068596006456691 0.7068583758488391 -1.474835274357933e-07 -0.09985985170652373 +2.3904 0.706859674767027 0.706858452198144 -1.4690877888148823e-07 -0.09985989425114168 +2.3905 0.7068597488720219 0.7068585285181502 -1.4631026255991497e-07 -0.09985993678285349 +2.3906 0.7068598229609134 0.706858604808611 -1.4568812367263262e-07 -0.099859979301663 +2.3907000000000003 0.7068598970339608 0.7068586810692816 -1.4504251283527225e-07 -0.09986002180757421 +2.3908 0.7068599710914207 0.706858757299919 -1.4437358603763828e-07 -0.09986006430059097 +2.3909000000000002 0.7068600451335488 0.7068588335002812 -1.4368150458819728e-07 -0.09986010678071716 +2.391 0.7068601191605985 0.7068589096701291 -1.4296643508632245e-07 -0.09986014924795682 +2.3911 0.7068601931728216 0.7068589858092247 -1.422285493875991e-07 -0.09986019170231375 +2.3912000000000004 0.7068602671704675 0.7068590619173316 -1.4146802455178298e-07 -0.09986023414379183 +2.3913 0.7068603411537844 0.7068591379942166 -1.406850428098405e-07 -0.09986027657239507 +2.3914 0.7068604151230176 0.706859214039647 -1.3987979151364183e-07 -0.09986031898812721 +2.3915 0.7068604890784109 0.7068592900533934 -1.390524630943274e-07 -0.09986036139099229 +2.3916 0.7068605630202061 0.706859366035228 -1.3820325501547048e-07 -0.09986040378099413 +2.3917 0.7068606369486422 0.706859441984925 -1.373323697314438e-07 -0.09986044615813663 +2.3918000000000004 0.7068607108639567 0.7068595179022613 -1.364400146284389e-07 -0.09986048852242374 +2.3919 0.7068607847663841 0.7068595937870158 -1.3552640197589394e-07 -0.0998605308738593 +2.392 0.7068608586561573 0.7068596696389697 -1.3459174889873804e-07 -0.09986057321244722 +2.3921 0.706860932533506 0.7068597454579069 -1.3363627729412464e-07 -0.09986061553819144 +2.3922000000000003 0.706861006398658 0.7068598212436135 -1.326602137915328e-07 -0.0998606578510958 +2.3923 0.7068610802518385 0.7068598969958775 -1.3166378970939918e-07 -0.09986070015116413 +2.3924000000000003 0.7068611540932699 0.7068599727144907 -1.3064724098225955e-07 -0.0998607424384004 +2.3925 0.7068612279231725 0.7068600483992469 -1.296108081243197e-07 -0.09986078471280851 +2.3926 0.7068613017417638 0.7068601240499424 -1.2855473615833168e-07 -0.09986082697439236 +2.3927000000000005 0.7068613755492581 0.7068601996663759 -1.2747927454967445e-07 -0.09986086922315579 +2.3928000000000003 0.7068614493458676 0.7068602752483493 -1.2638467717686341e-07 -0.09986091145910263 +2.3929 0.7068615231318014 0.7068603507956672 -1.2527120225348798e-07 -0.09986095368223684 +2.393 0.7068615969072656 0.7068604263081372 -1.241391122536184e-07 -0.09986099589256225 +2.3931 0.706861670672464 0.7068605017855694 -1.229886738753766e-07 -0.09986103809008277 +2.3932 0.7068617444275971 0.706860577227777 -1.2182015797154722e-07 -0.09986108027480227 +2.3933 0.7068618181728623 0.706860652634576 -1.2063383946978035e-07 -0.09986112244672465 +2.3934 0.7068618919084548 0.7068607280057858 -1.194299973274887e-07 -0.0998611646058538 +2.3935 0.7068619656345656 0.7068608033412285 -1.1820891445898929e-07 -0.09986120675219357 +2.3935999999999997 0.7068620393513831 0.7068608786407291 -1.1697087766437964e-07 -0.09986124888574782 +2.3937000000000004 0.7068621130590931 0.7068609539041165 -1.157161775705573e-07 -0.09986129100652047 +2.3938 0.7068621867578773 0.7068610291312218 -1.1444510855489198e-07 -0.09986133311451534 +2.3939 0.7068622604479146 0.70686110432188 -1.1315796868797967e-07 -0.09986137520973629 +2.394 0.7068623341293809 0.706861179475929 -1.1185505965211062e-07 -0.09986141729218723 +2.3941 0.7068624078024488 0.7068612545932101 -1.1053668667014571e-07 -0.09986145936187205 +2.3942 0.706862481467287 0.7068613296735679 -1.0920315844480111e-07 -0.09986150141879453 +2.3943000000000003 0.7068625551240615 0.7068614047168502 -1.0785478707538154e-07 -0.09986154346295861 +2.3944 0.7068626287729347 0.7068614797229085 -1.0649188799879972e-07 -0.09986158549436813 +2.3945 0.7068627024140652 0.7068615546915975 -1.0511477989850332e-07 -0.09986162751302698 +2.3946 0.7068627760476087 0.7068616296227759 -1.0372378464115761e-07 -0.09986166951893903 +2.3947000000000003 0.706862849673717 0.7068617045163048 -1.023192271959808e-07 -0.0998617115121081 +2.3948 0.7068629232925387 0.70686177937205 -1.00901435562753e-07 -0.09986175349253808 +2.3949000000000003 0.7068629969042184 0.7068618541898797 -9.947074069462103e-08 -0.09986179546023277 +2.395 0.7068630705088974 0.7068619289696665 -9.80274764200359e-08 -0.09986183741519608 +2.3951 0.7068631441067137 0.7068620037112868 -9.657197936642492e-08 -0.09986187935743192 +2.3952000000000004 0.7068632176978008 0.7068620784146198 -9.510458887605766e-08 -0.09986192128694403 +2.3953 0.7068632912822892 0.706862153079549 -9.362564693578962e-08 -0.09986196320373632 +2.3954 0.7068633648603055 0.7068622277059617 -9.213549809292815e-08 -0.09986200510781268 +2.3955 0.7068634384319727 0.7068623022937481 -9.063448937370044e-08 -0.09986204699917689 +2.3956 0.7068635119974098 0.7068623768428033 -8.912297019651738e-08 -0.09986208887783284 +2.3957 0.706863585556732 0.7068624513530253 -8.760129231212554e-08 -0.0998621307437844 +2.3958000000000004 0.7068636591100511 0.7068625258243162 -8.606980969518702e-08 -0.09986217259703538 +2.3959 0.7068637326574745 0.7068626002565823 -8.452887848182933e-08 -0.09986221443758966 +2.396 0.7068638061991062 0.7068626746497328 -8.297885687423567e-08 -0.09986225626545106 +2.3961 0.7068638797350459 0.7068627490036818 -8.14201050703886e-08 -0.09986229808062343 +2.3962000000000003 0.70686395326539 0.7068628233183467 -7.985298516172135e-08 -0.0998623398831106 +2.3963 0.7068640267902304 0.7068628975936488 -7.827786106372886e-08 -0.09986238167291644 +2.3964000000000003 0.7068641003096556 0.7068629718295136 -7.669509843443584e-08 -0.09986242345004478 +2.3965 0.70686417382375 0.7068630460258706 -7.510506457378274e-08 -0.0998624652144995 +2.3966 0.7068642473325935 0.7068631201826527 -7.350812835250214e-08 -0.09986250696628436 +2.3967 0.7068643208362624 0.7068631942997975 -7.19046601219131e-08 -0.09986254870540325 +2.3968000000000003 0.7068643943348292 0.7068632683772462 -7.029503162545025e-08 -0.09986259043186002 +2.3969 0.7068644678283622 0.7068633424149441 -6.867961591279503e-08 -0.09986263214565849 +2.397 0.7068645413169257 0.7068634164128401 -6.705878726007836e-08 -0.09986267384680242 +2.3971 0.70686461480058 0.7068634903708879 -6.54329210757719e-08 -0.09986271553529576 +2.3972 0.7068646882793814 0.7068635642890448 -6.380239381568661e-08 -0.09986275721114232 +2.3973 0.7068647617533819 0.7068636381672722 -6.216758289970606e-08 -0.09986279887434588 +2.3974 0.7068648352226296 0.7068637120055354 -6.052886661637655e-08 -0.0998628405249103 +2.3975 0.7068649086871687 0.7068637858038043 -5.888662404701303e-08 -0.09986288216283945 +2.3975999999999997 0.7068649821470387 0.7068638595620522 -5.724123496790405e-08 -0.09986292378813706 +2.3977000000000004 0.7068650556022759 0.706863933280257 -5.559307976552713e-08 -0.09986296540080704 +2.3978 0.706865129052912 0.7068640069584003 -5.394253934981261e-08 -0.09986300700085321 +2.3979 0.7068652024989741 0.7068640805964681 -5.2289995066756925e-08 -0.09986304858827932 +2.398 0.7068652759404862 0.7068641541944505 -5.063582860669914e-08 -0.09986309016308924 +2.3981 0.7068653493774679 0.7068642277523414 -4.898042192116262e-08 -0.09986313172528684 +2.3982 0.7068654228099343 0.7068643012701391 -4.732415713221572e-08 -0.09986317327487587 +2.3983000000000003 0.7068654962378964 0.7068643747478458 -4.566741644096515e-08 -0.09986321481186015 +2.3984 0.7068655696613622 0.7068644481854679 -4.40105820453192e-08 -0.09986325633624359 +2.3985 0.7068656430803337 0.7068645215830158 -4.235403604916553e-08 -0.09986329784802989 +2.3986 0.7068657164948101 0.7068645949405044 -4.069816037478792e-08 -0.0998633393472229 +2.3987000000000003 0.7068657899047867 0.706864668257952 -3.9043336671617124e-08 -0.09986338083382651 +2.3988 0.7068658633102536 0.7068647415353817 -3.738994623441426e-08 -0.09986342230784441 +2.3989000000000003 0.7068659367111979 0.70686481477282 -3.57383699100362e-08 -0.0998634637692805 +2.399 0.7068660101076019 0.7068648879702986 -3.408898801302365e-08 -0.09986350521813858 +2.3991 0.7068660834994442 0.7068649611278517 -3.2442180235422655e-08 -0.09986354665442247 +2.3992000000000004 0.7068661568866992 0.7068650342455189 -3.079832556259626e-08 -0.09986358807813599 +2.3993 0.7068662302693371 0.7068651073233432 -2.915780218399472e-08 -0.0998636294892829 +2.3994 0.7068663036473242 0.7068651803613715 -2.7520987404359293e-08 -0.09986367088786699 +2.3995 0.7068663770206227 0.7068652533596554 -2.5888257561973438e-08 -0.09986371227389212 +2.3996 0.7068664503891908 0.70686532631825 -2.4259987936939287e-08 -0.09986375364736205 +2.3997 0.706866523752983 0.7068653992372149 -2.2636552668778287e-08 -0.09986379500828066 +2.3998000000000004 0.706866597111949 0.706865472116613 -2.1018324670128707e-08 -0.09986383635665169 +2.3999 0.7068666704660354 0.7068655449565119 -1.940567553784106e-08 -0.09986387769247895 +2.4 0.706866743815184 0.7068656177569823 -1.7798975467976652e-08 -0.09986391901576622 +2.4001 0.7068668171593334 0.7068656905180999 -1.6198593178178705e-08 -0.09986396032651734 +2.4002000000000003 0.7068668904984179 0.7068657632399438 -1.4604895814430974e-08 -0.09986400162473612 +2.4003 0.7068669638323678 0.7068658359225969 -1.301824886952574e-08 -0.09986404291042632 +2.4004000000000003 0.7068670371611095 0.7068659085661462 -1.143901610283285e-08 -0.09986408418359174 +2.4005 0.7068671104845661 0.7068659811706823 -9.867559448793056e-09 -0.09986412544423623 +2.4006 0.7068671838026557 0.7068660537363003 -8.304238945794351e-09 -0.09986416669236349 +2.4007 0.7068672571152934 0.7068661262630984 -6.749412640762176e-09 -0.09986420792797736 +2.4008000000000003 0.7068673304223902 0.7068661987511793 -5.203436517602078e-09 -0.09986424915108165 +2.4009 0.7068674037238536 0.7068662712006488 -3.666664414800347e-09 -0.09986429036168008 +2.401 0.7068674770195867 0.7068663436116172 -2.139447933049987e-09 -0.0998643315597765 +2.4011 0.7068675503094898 0.7068664159841977 -6.221363641270572e-10 -0.09986437274537473 +2.4012000000000002 0.7068676235934586 0.7068664883185081 8.849233837024406e-10 -0.09986441391847849 +2.4013 0.7068676968713852 0.7068665606146691 2.381386874153457e-09 -0.09986445507909157 +2.4014 0.7068677701431586 0.7068666328728057 3.8669122227191766e-09 -0.09986449622721776 +2.4015 0.7068678434086637 0.7068667050930459 5.341160162590508e-09 -0.09986453736286081 +2.4015999999999997 0.7068679166677818 0.7068667772755224 6.8037941365964305e-09 -0.09986457848602458 +2.4017000000000004 0.7068679899203909 0.7068668494203703 8.254480363123484e-09 -0.09986461959671283 +2.4018 0.7068680631663653 0.7068669215277286 9.692887921984583e-09 -0.09986466069492929 +2.4019 0.7068681364055753 0.7068669935977401 1.111868882207323e-08 -0.09986470178067777 +2.402 0.7068682096378889 0.7068670656305511 1.2531558075956628e-08 -0.0998647428539621 +2.4021 0.7068682828631694 0.7068671376263109 1.3931173778805594e-08 -0.09986478391478598 +2.4022 0.7068683560812772 0.7068672095851727 1.5317217182120313e-08 -0.09986482496315319 +2.4023000000000003 0.7068684292920695 0.7068672815072927 1.6689372761384547e-08 -0.09986486599906758 +2.4024 0.7068685024953998 0.7068673533928304 1.8047328285454578e-08 -0.0998649070225328 +2.4025 0.7068685756911186 0.706867425241949 1.939077490156066e-08 -0.0998649480335527 +2.4026 0.7068686488790727 0.706867497054815 2.0719407192552886e-08 -0.09986498903213105 +2.4027000000000003 0.7068687220591061 0.7068675688315976 2.20329232471575e-08 -0.0998650300182716 +2.4028 0.7068687952310595 0.7068676405724696 2.333102473196791e-08 -0.09986507099197811 +2.4029000000000003 0.7068688683947704 0.7068677122776073 2.4613416962568357e-08 -0.09986511195325441 +2.403 0.7068689415500728 0.7068677839471889 2.5879808955575623e-08 -0.09986515290210418 +2.4031 0.7068690146967982 0.706867855581397 2.712991352404881e-08 -0.09986519383853126 +2.4032000000000004 0.7068690878347748 0.7068679271804166 2.836344730264284e-08 -0.09986523476253932 +2.4033 0.7068691609638278 0.7068679987444357 2.958013085342659e-08 -0.09986527567413223 +2.4034 0.7068692340837797 0.7068680702736456 3.077968868669956e-08 -0.09986531657331367 +2.4035 0.7068693071944494 0.70686814176824 3.1961849366810013e-08 -0.09986535746008744 +2.4036 0.7068693802956536 0.7068682132284158 3.312634553991056e-08 -0.09986539833445729 +2.4037 0.7068694533872062 0.7068682846543723 3.4272914012020705e-08 -0.09986543919642694 +2.4038000000000004 0.7068695264689179 0.7068683560463125 3.540129579933382e-08 -0.09986548004600024 +2.4039 0.7068695995405969 0.7068684274044412 3.651123619240193e-08 -0.09986552088318086 +2.404 0.7068696726020489 0.7068684987289662 3.760248480470796e-08 -0.0998655617079726 +2.4041 0.7068697456530764 0.7068685700200981 3.867479564725884e-08 -0.09986560252037922 +2.4042000000000003 0.7068698186934799 0.7068686412780496 3.972792716328e-08 -0.09986564332040443 +2.4043 0.7068698917230567 0.7068687125030366 4.076164229586954e-08 -0.09986568410805198 +2.4044 0.7068699647416026 0.7068687836952772 4.177570854524415e-08 -0.0998657248833257 +2.4045 0.7068700377489099 0.7068688548549915 4.2769897996494666e-08 -0.09986576564622922 +2.4046 0.7068701107447696 0.7068689259824027 4.374398739764862e-08 -0.0998658063967664 +2.4047 0.7068701837289693 0.706868997077736 4.469775819956889e-08 -0.09986584713494094 +2.4048000000000003 0.7068702567012946 0.7068690681412185 4.563099660799541e-08 -0.09986588786075654 +2.4049 0.7068703296615293 0.7068691391730806 4.654349361303545e-08 -0.099865928574217 +2.405 0.706870402609455 0.7068692101735536 4.743504507416507e-08 -0.0998659692753261 +2.4051 0.7068704755448504 0.7068692811428718 4.8305451720229153e-08 -0.09986600996408747 +2.4052000000000002 0.7068705484674926 0.7068693520812713 4.9154519229238636e-08 -0.09986605064050491 +2.4053 0.7068706213771573 0.7068694229889905 4.9982058256126116e-08 -0.0998660913045822 +2.4054 0.706870694273617 0.706869493866269 5.0787884483052825e-08 -0.09986613195632302 +2.4055 0.7068707671566432 0.7068695647133493 5.157181864022531e-08 -0.09986617259573115 +2.4055999999999997 0.7068708400260053 0.7068696355304749 5.233368657701909e-08 -0.09986621322281025 +2.4057000000000004 0.7068709128814703 0.7068697063178917 5.307331927759118e-08 -0.0998662538375641 +2.4058 0.7068709857228048 0.7068697770758472 5.3790552899044e-08 -0.0998662944399965 +2.4059 0.7068710585497723 0.7068698478045905 5.4485228826936516e-08 -0.09986633503011111 +2.406 0.7068711313621354 0.7068699185043723 5.5157193689162054e-08 -0.09986637560791167 +2.4061 0.706871204159655 0.706869989175445 5.580629938370385e-08 -0.09986641617340192 +2.4062 0.7068712769420904 0.7068700598180625 5.6432403149758725e-08 -0.09986645672658562 +2.4063000000000003 0.7068713497091994 0.7068701304324799 5.703536756600236e-08 -0.0998664972674664 +2.4064 0.7068714224607384 0.7068702010189543 5.761506057487542e-08 -0.09986653779604808 +2.4065 0.7068714951964628 0.7068702715777438 5.817135554503361e-08 -0.09986657831233439 +2.4066 0.7068715679161262 0.7068703421091076 5.870413126787821e-08 -0.09986661881632902 +2.4067000000000003 0.706871640619481 0.7068704126133063 5.921327199745474e-08 -0.0998666593080357 +2.4068 0.7068717133062791 0.7068704830906016 5.969866746606545e-08 -0.09986669978745814 +2.4069000000000003 0.7068717859762702 0.7068705535412565 6.01602129276374e-08 -0.09986674025460006 +2.407 0.7068718586292038 0.7068706239655349 6.059780916639612e-08 -0.0998667807094652 +2.4071 0.7068719312648282 0.706870694363702 6.10113625072739e-08 -0.09986682115205729 +2.4072000000000005 0.7068720038828904 0.7068707647360235 6.14007848662168e-08 -0.09986686158238005 +2.4073 0.7068720764831371 0.7068708350827664 6.176599373630687e-08 -0.09986690200043717 +2.4074 0.7068721490653135 0.706870905404198 6.210691222592601e-08 -0.09986694240623237 +2.4075 0.7068722216291645 0.7068709757005867 6.242346906222551e-08 -0.09986698279976935 +2.4076 0.7068722941744348 0.7068710459722015 6.271559862061626e-08 -0.09986702318105188 +2.4077 0.7068723667008672 0.7068711162193122 6.298324091782992e-08 -0.09986706355008365 +2.4078000000000004 0.7068724392082049 0.7068711864421888 6.322634165008278e-08 -0.09986710390686832 +2.4079 0.7068725116961903 0.7068712566411022 6.344485217919804e-08 -0.09986714425140965 +2.408 0.7068725841645651 0.7068713268163236 6.363872956383076e-08 -0.09986718458371133 +2.4081 0.7068726566130712 0.7068713969681244 6.38079365351818e-08 -0.09986722490377709 +2.4082000000000003 0.7068727290414498 0.7068714670967765 6.395244154903945e-08 -0.09986726521161061 +2.4083 0.7068728014494416 0.7068715372025522 6.407221874935032e-08 -0.09986730550721562 +2.4084 0.7068728738367875 0.7068716072857242 6.416724799770956e-08 -0.09986734579059584 +2.4085 0.7068729462032282 0.7068716773465644 6.423751487509566e-08 -0.09986738606175494 +2.4086 0.7068730185485039 0.7068717473853459 6.428301065931896e-08 -0.09986742632069662 +2.4087 0.7068730908723553 0.7068718174023412 6.430373236318565e-08 -0.0998674665674246 +2.4088000000000003 0.7068731631745229 0.7068718873978226 6.429968270674213e-08 -0.09986750680194255 +2.4089 0.7068732354547473 0.7068719573720629 6.427087011033616e-08 -0.09986754702425425 +2.409 0.7068733077127691 0.7068720273253342 6.421730871716824e-08 -0.09986758723436329 +2.4091 0.7068733799483294 0.7068720972579086 6.413901836380131e-08 -0.0998676274322734 +2.4092000000000002 0.7068734521611697 0.706872167170058 6.403602459924274e-08 -0.09986766761798832 +2.4093 0.7068735243510313 0.7068722370620539 6.390835863984146e-08 -0.09986770779151172 +2.4094 0.7068735965176565 0.7068723069341676 6.375605738663526e-08 -0.09986774795284731 +2.4095 0.7068736686607875 0.7068723767866691 6.357916343402437e-08 -0.09986778810199874 +2.4095999999999997 0.7068737407801677 0.7068724466198291 6.337772501079086e-08 -0.09986782823896978 +2.4097000000000004 0.7068738128755403 0.7068725164339165 6.315179599397647e-08 -0.099867868363764 +2.4098 0.7068738849466498 0.7068725862292004 6.29014358915353e-08 -0.0998679084763852 +2.4099 0.7068739569932412 0.7068726560059488 6.262670984580332e-08 -0.09986794857683703 +2.41 0.7068740290150601 0.7068727257644292 6.232768857625248e-08 -0.0998679886651232 +2.4101 0.7068741010118531 0.7068727955049077 6.200444839510322e-08 -0.09986802874124731 +2.4102 0.7068741729833674 0.7068728652276504 6.165707116916053e-08 -0.09986806880521315 +2.4103000000000003 0.7068742449293516 0.7068729349329215 6.128564432328343e-08 -0.0998681088570243 +2.4104 0.706874316849555 0.706873004620985 6.089026077446547e-08 -0.09986814889668454 +2.4105 0.7068743887437285 0.7068730742921034 6.047101896479445e-08 -0.09986818892419752 +2.4106 0.7068744606116231 0.7068731439465381 6.002802278859409e-08 -0.0998682289395669 +2.4107000000000003 0.7068745324529917 0.7068732135845497 5.956138159242397e-08 -0.09986826894279639 +2.4108 0.7068746042675882 0.7068732832063966 5.907121014732397e-08 -0.09986830893388965 +2.4109000000000003 0.7068746760551683 0.706873352812337 5.855762861411984e-08 -0.09986834891285036 +2.411 0.7068747478154883 0.706873422402627 5.80207625104634e-08 -0.09986838887968219 +2.4111 0.7068748195483062 0.7068734919775215 5.746074269001589e-08 -0.09986842883438878 +2.4112000000000005 0.7068748912533815 0.7068735615372743 5.687770531295766e-08 -0.09986846877697382 +2.4113 0.7068749629304758 0.7068736310821371 5.627179179047703e-08 -0.09986850870744104 +2.4114 0.7068750345793513 0.7068737006123604 5.5643148777831386e-08 -0.09986854862579408 +2.4115 0.7068751061997725 0.706873770128193 5.4991928125774914e-08 -0.09986858853203663 +2.4116 0.706875177791505 0.7068738396298815 5.431828685106832e-08 -0.0998686284261723 +2.4117 0.7068752493543169 0.7068739091176716 5.36223870757635e-08 -0.09986866830820482 +2.4118000000000004 0.7068753208879774 0.7068739785918066 5.290439602720354e-08 -0.09986870817813781 +2.4119 0.706875392392258 0.706874048052528 5.216448596516432e-08 -0.09986874803597494 +2.412 0.7068754638669321 0.7068741175000759 5.140283415236424e-08 -0.09986878788171996 +2.4120999999999997 0.7068755353117747 0.7068741869346876 5.061962281109611e-08 -0.09986882771537639 +2.4122000000000003 0.7068756067265632 0.7068742563565988 4.981503909894103e-08 -0.09986886753694796 +2.4123 0.7068756781110772 0.7068743257660435 4.898927500815442e-08 -0.09986890734643841 +2.4124 0.7068757494650977 0.706874395163253 4.814252738821745e-08 -0.09986894714385129 +2.4125 0.7068758207884085 0.7068744645484565 4.7274997860835555e-08 -0.09986898692919027 +2.4126 0.7068758920807956 0.7068745339218814 4.638689277310093e-08 -0.09986902670245912 +2.4127 0.7068759633420469 0.7068746032837521 4.547842316106332e-08 -0.09986906646366134 +2.4128000000000003 0.7068760345719529 0.7068746726342914 4.454980468727998e-08 -0.09986910621280069 +2.4129 0.7068761057703064 0.7068747419737194 4.360125759918232e-08 -0.09986914594988074 +2.413 0.7068761769369027 0.7068748113022538 4.26330066787689e-08 -0.09986918567490527 +2.4131 0.7068762480715394 0.7068748806201096 4.164528117668598e-08 -0.09986922538787779 +2.4132000000000002 0.7068763191740168 0.7068749499275 4.0638314768859374e-08 -0.09986926508880206 +2.4133 0.7068763902441377 0.7068750192246349 3.961234549057502e-08 -0.09986930477768173 +2.4134 0.7068764612817076 0.7068750885117216 3.8567615698315016e-08 -0.09986934445452036 +2.4135 0.7068765322865341 0.7068751577889653 3.750437198822565e-08 -0.09986938411932167 +2.4135999999999997 0.7068766032584285 0.7068752270565681 3.642286516662707e-08 -0.09986942377208934 +2.4137000000000004 0.7068766741972038 0.7068752963147296 3.5323350168481316e-08 -0.09986946341282692 +2.4138 0.7068767451026764 0.706875365563646 3.4206086003615854e-08 -0.09986950304153808 +2.4139 0.7068768159746657 0.7068754348035116 3.307133569774301e-08 -0.09986954265822652 +2.414 0.7068768868129931 0.7068755040345167 3.191936623347935e-08 -0.09986958226289583 +2.4141 0.7068769576174838 0.7068755732568499 3.0750448474017866e-08 -0.09986962185554965 +2.4142 0.7068770283879657 0.7068756424706959 2.956485711108625e-08 -0.09986966143619164 +2.4143000000000003 0.7068770991242697 0.706875711676237 2.836287060770104e-08 -0.09986970100482544 +2.4144 0.7068771698262294 0.706875780873652 2.7144771121839772e-08 -0.09986974056145467 +2.4145 0.7068772404936818 0.7068758500631172 2.591084442664371e-08 -0.09986978010608304 +2.4146 0.7068773111264671 0.7068759192448051 2.4661379879192813e-08 -0.09986981963871411 +2.4147000000000003 0.7068773817244283 0.7068759884188853 2.3396670326830682e-08 -0.09986985915935148 +2.4148 0.7068774522874122 0.7068760575855246 2.2117012030836714e-08 -0.0998698986679989 +2.4149000000000003 0.7068775228152677 0.706876126744886 2.0822704622190658e-08 -0.0998699381646599 +2.415 0.7068775933078483 0.7068761958971295 1.951405102351006e-08 -0.09986997764933819 +2.4151 0.7068776637650098 0.706876265042412 1.8191357364916172e-08 -0.09987001712203734 +2.4152000000000005 0.7068777341866118 0.7068763341808868 1.685493292158391e-08 -0.099870056582761 +2.4153000000000002 0.706877804572517 0.7068764033127037 1.5505090047822356e-08 -0.09987009603151281 +2.4154 0.7068778749225919 0.7068764724380097 1.4142144092073317e-08 -0.09987013546829639 +2.4155 0.706877945236706 0.7068765415569476 1.2766413336195992e-08 -0.09987017489311535 +2.4156 0.7068780155147323 0.7068766106696573 1.1378218908730808e-08 -0.09987021430597333 +2.4157 0.7068780857565476 0.706876679776275 9.977884714643115e-09 -0.09987025370687398 +2.4158000000000004 0.706878155962032 0.7068767488769336 8.565737365066883e-09 -0.09987029309582092 +2.4159 0.7068782261310687 0.7068768179717622 7.142106091435896e-09 -0.0998703324728177 +2.416 0.7068782962635451 0.7068768870608864 5.707322676094806e-09 -0.099870371837868 +2.4160999999999997 0.7068783663593523 0.7068769561444282 4.261721375971306e-09 -0.09987041119097544 +2.4162000000000003 0.7068784364183844 0.7068770252225063 2.8056388410441224e-09 -0.09987045053214363 +2.4163 0.7068785064405396 0.706877094295235 1.339414029341568e-09 -0.09987048986137621 +2.4164 0.7068785764257197 0.7068771633627257 -1.3661185550850607e-10 -0.09987052917867678 +2.4165 0.7068786463738297 0.7068772324250855 -1.6220954588211378e-09 -0.09987056848404892 +2.4166 0.7068787162847789 0.7068773014824183 -3.1166913477126412e-09 -0.09987060777749626 +2.4167 0.7068787861584804 0.7068773705348241 -4.620052092632609e-09 -0.09987064705902243 +2.4168000000000003 0.7068788559948503 0.706877439582399 -6.131828342824386e-09 -0.09987068632863103 +2.4169 0.7068789257938095 0.7068775086252354 -7.651668917398047e-09 -0.09987072558632568 +2.417 0.7068789955552817 0.706877577663422 -9.179220882525596e-09 -0.09987076483210999 +2.4171 0.7068790652791953 0.7068776466970434 -1.0714129626901436e-08 -0.09987080406598758 +2.4172000000000002 0.7068791349654819 0.706877715726181 -1.2256038958886883e-08 -0.09987084328796204 +2.4173 0.706879204614077 0.7068777847509115 -1.3804591172429659e-08 -0.099870882498037 +2.4174 0.7068792742249201 0.7068778537713083 -1.5359427140305276e-08 -0.09987092169621599 +2.4175 0.7068793437979548 0.7068779227874407 -1.6920186395649045e-08 -0.09987096088250269 +2.4175999999999997 0.7068794133331284 0.7068779917993745 -1.8486507214355435e-08 -0.09987100005690074 +2.4177000000000004 0.7068794828303919 0.706878060807171 -2.0058026698778486e-08 -0.09987103921941363 +2.4178 0.7068795522897005 0.7068781298108878 -2.1634380862299574e-08 -0.09987107837004502 +2.4179 0.7068796217110128 0.706878198810579 -2.321520471302782e-08 -0.09987111750879851 +2.418 0.7068796910942922 0.7068782678062944 -2.4800132339235226e-08 -0.09987115663567775 +2.4181 0.7068797604395052 0.7068783367980795 -2.6388796993057073e-08 -0.09987119575068623 +2.4182 0.7068798297466226 0.7068784057859767 -2.7980831176794424e-08 -0.0998712348538276 +2.4183000000000003 0.7068798990156191 0.7068784747700236 -2.9575866725747163e-08 -0.09987127394510543 +2.4184 0.7068799682464737 0.7068785437502548 -3.117353489321545e-08 -0.0998713130245234 +2.4185 0.706880037439169 0.7068786127266997 -3.2773466440271654e-08 -0.09987135209208503 +2.4186 0.7068801065936916 0.7068786816993851 -3.437529171555764e-08 -0.09987139114779396 +2.4187000000000003 0.706880175710032 0.7068787506683321 -3.597864074299673e-08 -0.0998714301916537 +2.4188 0.7068802447881848 0.7068788196335596 -3.758314330668672e-08 -0.09987146922366791 +2.4189000000000003 0.7068803138281488 0.7068788885950814 -3.9188429037852884e-08 -0.09987150824384015 +2.419 0.7068803828299262 0.7068789575529077 -4.0794127498440004e-08 -0.09987154725217401 +2.4191 0.7068804517935239 0.706879026507045 -4.2399868267116664e-08 -0.0998715862486731 +2.4192000000000005 0.706880520718952 0.706879095457495 -4.4005281023578766e-08 -0.09987162523334098 +2.4193000000000002 0.7068805896062251 0.7068791644042564 -4.560999563842311e-08 -0.09987166420618122 +2.4194 0.7068806584553617 0.7068792333473232 -4.7213642252741383e-08 -0.09987170316719746 +2.4195 0.7068807272663842 0.7068793022866856 -4.8815851366604615e-08 -0.09987174211639323 +2.4196 0.7068807960393189 0.7068793712223302 -5.041625392252641e-08 -0.09987178105377216 +2.4197 0.7068808647741962 0.7068794401542391 -5.201448139335787e-08 -0.0998718199793378 +2.4198000000000004 0.7068809334710504 0.7068795090823909 -5.361016586257275e-08 -0.09987185889309373 +2.4199 0.7068810021299194 0.7068795780067598 -5.520294011165418e-08 -0.09987189779504352 +2.42 0.7068810707508459 0.7068796469273166 -5.6792437706830803e-08 -0.09987193668519076 +2.4200999999999997 0.7068811393338754 0.7068797158440278 -5.837829307833199e-08 -0.09987197556353902 +2.4202000000000004 0.7068812078790583 0.7068797847568561 -5.996014160636505e-08 -0.09987201443009192 +2.4203 0.7068812763864479 0.7068798536657602 -6.153761970958613e-08 -0.09987205328485295 +2.4204 0.7068813448561027 0.7068799225706953 -6.311036491969332e-08 -0.09987209212782577 +2.4205 0.7068814132880836 0.706879991471612 -6.467801597163231e-08 -0.09987213095901387 +2.4206 0.7068814816824566 0.7068800603684575 -6.624021288512832e-08 -0.09987216977842087 +2.4207 0.7068815500392909 0.7068801292611753 -6.779659704686872e-08 -0.09987220858605034 +2.4208000000000003 0.7068816183586597 0.7068801981497046 -6.934681128639708e-08 -0.09987224738190582 +2.4209 0.70688168664064 0.7068802670339815 -7.089049997412514e-08 -0.09987228616599092 +2.421 0.7068817548853126 0.7068803359139373 -7.24273090855175e-08 -0.09987232493830916 +2.4211 0.706881823092762 0.7068804047895003 -7.395688629433309e-08 -0.09987236369886417 +2.4212000000000002 0.7068818912630765 0.7068804736605947 -7.547888104374872e-08 -0.09987240244765944 +2.4213 0.7068819593963482 0.706880542527141 -7.699294463699852e-08 -0.09987244118469851 +2.4214 0.706882027492673 0.7068806113890564 -7.849873030849747e-08 -0.09987247990998507 +2.4215 0.7068820955521503 0.7068806802462535 -7.999589330710821e-08 -0.09987251862352259 +2.4215999999999998 0.7068821635748832 0.706880749098642 -8.148409097550463e-08 -0.0998725573253146 +2.4217000000000004 0.7068822315609786 0.7068808179461279 -8.29629828256323e-08 -0.09987259601536475 +2.4218 0.706882299510547 0.7068808867886129 -8.443223062024052e-08 -0.09987263469367658 +2.4219 0.7068823674237021 0.7068809556259958 -8.589149844660804e-08 -0.09987267336025356 +2.422 0.706882435300562 0.7068810244581716 -8.734045279807506e-08 -0.09987271201509931 +2.4221 0.7068825031412478 0.7068810932850316 -8.877876264603429e-08 -0.09987275065821744 +2.4222 0.7068825709458839 0.7068811621064639 -9.020609951539138e-08 -0.09987278928961141 +2.4223000000000003 0.7068826387145987 0.7068812309223527 -9.162213756089277e-08 -0.09987282790928484 +2.4224 0.7068827064475236 0.7068812997325788 -9.302655364258616e-08 -0.09987286651724123 +2.4225 0.7068827741447941 0.7068813685370199 -9.441902740214836e-08 -0.09987290511348414 +2.4226 0.7068828418065485 0.7068814373355501 -9.579924132793738e-08 -0.09987294369801716 +2.4227000000000003 0.7068829094329283 0.7068815061280401 -9.716688082785085e-08 -0.09987298227084382 +2.4228 0.706882977024079 0.7068815749143571 -9.852163431432748e-08 -0.09987302083196758 +2.4229000000000003 0.7068830445801491 0.7068816436943652 -9.986319326159288e-08 -0.0998730593813921 +2.423 0.7068831121012904 0.7068817124679255 -1.0119125227418119e-07 -0.09987309791912093 +2.4231 0.706883179587658 0.7068817812348952 -1.025055091675997e-07 -0.09987313644515754 +2.4232000000000005 0.7068832470394095 0.7068818499951286 -1.0380566503685046e-07 -0.09987317495950546 +2.4233000000000002 0.7068833144567072 0.7068819187484768 -1.0509142431020663e-07 -0.09987321346216828 +2.4234 0.7068833818397149 0.7068819874947883 -1.0636249483247928e-07 -0.09987325195314956 +2.4235 0.7068834491886007 0.7068820562339075 -1.0761858791792644e-07 -0.09987329043245283 +2.4236 0.7068835165035349 0.7068821249656765 -1.0885941842397884e-07 -0.09987332890008156 +2.4237 0.7068835837846913 0.7068821936899341 -1.1008470482062882e-07 -0.09987336735603941 +2.4238000000000004 0.7068836510322467 0.7068822624065163 -1.1129416924160473e-07 -0.09987340580032981 +2.4239 0.7068837182463804 0.7068823311152559 -1.1248753755375984e-07 -0.09987344423295634 +2.424 0.7068837854272751 0.706882399815983 -1.136645394143182e-07 -0.09987348265392254 +2.4240999999999997 0.7068838525751161 0.7068824685085245 -1.1482490835414139e-07 -0.09987352106323193 +2.4242000000000004 0.7068839196900916 0.7068825371927052 -1.1596838179854518e-07 -0.09987355946088802 +2.4243 0.706883986772392 0.7068826058683464 -1.1709470116097465e-07 -0.09987359784689435 +2.4244 0.7068840538222114 0.706882674535267 -1.1820361188810691e-07 -0.09987363622125447 +2.4245 0.7068841208397465 0.7068827431932831 -1.1929486351709706e-07 -0.09987367458397192 +2.4246 0.7068841878251957 0.7068828118422085 -1.2036820973282403e-07 -0.09987371293505024 +2.4247 0.7068842547787606 0.7068828804818538 -1.2142340841993227e-07 -0.09987375127449288 +2.4248000000000003 0.7068843217006452 0.7068829491120274 -1.2246022173048599e-07 -0.09987378960230338 +2.4249 0.7068843885910565 0.7068830177325355 -1.234784161256025e-07 -0.09987382791848534 +2.425 0.7068844554502034 0.7068830863431812 -1.244777624222898e-07 -0.09987386622304224 +2.4251 0.7068845222782971 0.7068831549437657 -1.2545803586977433e-07 -0.09987390451597761 +2.4252000000000002 0.7068845890755517 0.7068832235340878 -1.264190161633788e-07 -0.09987394279729495 +2.4253 0.7068846558421833 0.7068832921139436 -1.2736048753299312e-07 -0.09987398106699781 +2.4254000000000002 0.7068847225784102 0.7068833606831272 -1.2828223876909517e-07 -0.09987401932508971 +2.4255 0.7068847892844528 0.7068834292414307 -1.2918406326438425e-07 -0.09987405757157415 +2.4255999999999998 0.706884855960534 0.7068834977886436 -1.3006575907276163e-07 -0.09987409580645464 +2.4257000000000004 0.7068849226068787 0.7068835663245536 -1.3092712896137226e-07 -0.09987413402973473 +2.4258 0.7068849892237139 0.706883634848946 -1.317679804348909e-07 -0.09987417224141792 +2.4259 0.7068850558112684 0.7068837033616047 -1.3258812578756385e-07 -0.09987421044150772 +2.426 0.706885122369773 0.7068837718623108 -1.3338738214657697e-07 -0.0998742486300076 +2.4261 0.7068851888994603 0.7068838403508442 -1.341655715188933e-07 -0.09987428680692112 +2.4262 0.7068852554005651 0.7068839088269827 -1.3492252081206968e-07 -0.09987432497225174 +2.4263000000000003 0.706885321873324 0.7068839772905025 -1.3565806190017626e-07 -0.09987436312600306 +2.4264 0.7068853883179751 0.7068840457411777 -1.3637203162726597e-07 -0.09987440126817854 +2.4265 0.706885454734758 0.7068841141787807 -1.370642718698245e-07 -0.09987443939878168 +2.4266 0.7068855211239142 0.706884182603083 -1.3773462956799543e-07 -0.099874477517816 +2.4267000000000003 0.706885587485687 0.7068842510138531 -1.383829567550704e-07 -0.09987451562528497 +2.4268 0.706885653820321 0.7068843194108596 -1.3900911057483645e-07 -0.09987455372119215 +2.4269000000000003 0.706885720128062 0.7068843877938683 -1.3961295333708712e-07 -0.09987459180554102 +2.427 0.7068857864091576 0.7068844561626444 -1.4019435254711277e-07 -0.09987462987833506 +2.4271 0.7068858526638566 0.7068845245169517 -1.4075318091957834e-07 -0.09987466793957783 +2.4272000000000005 0.7068859188924093 0.7068845928565521 -1.4128931640627895e-07 -0.0998747059892728 +2.4273000000000002 0.7068859850950668 0.7068846611812067 -1.4180264223777328e-07 -0.09987474402742347 +2.4274 0.7068860512720816 0.7068847294906753 -1.4229304693552658e-07 -0.09987478205403327 +2.4275 0.7068861174237077 0.7068847977847168 -1.4276042433793157e-07 -0.09987482006910581 +2.4276 0.7068861835501994 0.7068848660630886 -1.432046736436765e-07 -0.0998748580726445 +2.4277 0.7068862496518127 0.7068849343255474 -1.4362569939613268e-07 -0.09987489606465286 +2.4278000000000004 0.7068863157288046 0.706885002571849 -1.440234115284572e-07 -0.09987493404513441 +2.4279 0.7068863817814321 0.706885070801748 -1.4439772537573614e-07 -0.09987497201409261 +2.428 0.7068864478099545 0.7068851390149982 -1.4474856170967887e-07 -0.09987500997153098 +2.4280999999999997 0.7068865138146303 0.7068852072113527 -1.4507584671606677e-07 -0.09987504791745301 +2.4282000000000004 0.7068865797957199 0.7068852753905642 -1.4537951205026434e-07 -0.09987508585186217 +2.4283 0.7068866457534836 0.7068853435523843 -1.4565949484068863e-07 -0.09987512377476196 +2.4284 0.706886711688183 0.7068854116965638 -1.459157376836051e-07 -0.09987516168615586 +2.4285 0.7068867776000793 0.7068854798228538 -1.4614818866567902e-07 -0.09987519958604738 +2.4286 0.7068868434894354 0.7068855479310039 -1.4635680138652685e-07 -0.09987523747443995 +2.4287 0.7068869093565135 0.7068856160207639 -1.4654153495871625e-07 -0.09987527535133708 +2.4288000000000003 0.7068869752015772 0.7068856840918833 -1.4670235399735776e-07 -0.09987531321674233 +2.4289 0.7068870410248893 0.7068857521441108 -1.4683922866867705e-07 -0.09987535107065906 +2.429 0.7068871068267137 0.7068858201771949 -1.4695213464317736e-07 -0.0998753889130908 +2.4291 0.7068871726073143 0.7068858881908846 -1.4704105314768123e-07 -0.09987542674404107 +2.4292000000000002 0.7068872383669549 0.7068859561849278 -1.4710597093237077e-07 -0.0998754645635133 +2.4293 0.7068873041058994 0.7068860241590731 -1.4714688030374734e-07 -0.09987550237151097 +2.4294000000000002 0.706887369824412 0.7068860921130686 -1.4716377908126355e-07 -0.09987554016803757 +2.4295 0.706887435522757 0.7068861600466628 -1.47156670642426e-07 -0.09987557795309661 +2.4295999999999998 0.7068875012011978 0.7068862279596042 -1.4712556389677445e-07 -0.09987561572669154 +2.4297000000000004 0.7068875668599981 0.7068862958516411 -1.4707047328067768e-07 -0.0998756534888258 +2.4298 0.7068876324994215 0.7068863637225224 -1.4699141876427235e-07 -0.09987569123950288 +2.4299 0.7068876981197314 0.7068864315719972 -1.4688842583064632e-07 -0.09987572897872624 +2.43 0.7068877637211903 0.706886499399815 -1.4676152548798171e-07 -0.0998757667064994 +2.4301 0.706887829304061 0.7068865672057256 -1.4661075423312575e-07 -0.0998758044228258 +2.4302 0.7068878948686054 0.7068866349894793 -1.4643615406199906e-07 -0.09987584212770893 +2.4303000000000003 0.7068879604150846 0.706886702750827 -1.4623777245745262e-07 -0.0998758798211522 +2.4304 0.7068880259437599 0.7068867704895199 -1.4601566236671637e-07 -0.09987591750315913 +2.4305 0.7068880914548914 0.70688683820531 -1.457698822013992e-07 -0.09987595517373316 +2.4306 0.7068881569487389 0.70688690589795 -1.4550049580799862e-07 -0.09987599283287779 +2.4307000000000003 0.7068882224255606 0.7068869735671938 -1.4520757246096194e-07 -0.09987603048059644 +2.4308 0.7068882878856153 0.706887041212795 -1.4489118683493063e-07 -0.09987606811689258 +2.4309000000000003 0.7068883533291592 0.7068871088345092 -1.4455141900820978e-07 -0.09987610574176968 +2.431 0.7068884187564493 0.7068871764320925 -1.4418835440725697e-07 -0.0998761433552312 +2.4311 0.7068884841677405 0.7068872440053018 -1.4380208382229476e-07 -0.09987618095728065 +2.4312000000000005 0.7068885495632868 0.706887311553895 -1.4339270335179954e-07 -0.0998762185479214 +2.4313000000000002 0.7068886149433413 0.7068873790776313 -1.4296031441117518e-07 -0.09987625612715692 +2.4314 0.7068886803081561 0.7068874465762711 -1.42505023682446e-07 -0.09987629369499071 +2.4315 0.7068887456579815 0.7068875140495763 -1.4202694309690955e-07 -0.0998763312514262 +2.4316 0.7068888109930673 0.7068875814973092 -1.4152618981778942e-07 -0.09987636879646682 +2.4317 0.7068888763136616 0.7068876489192344 -1.4100288618298928e-07 -0.0998764063301161 +2.4318 0.7068889416200111 0.7068877163151173 -1.404571597068277e-07 -0.09987644385237748 +2.4319 0.706889006912361 0.7068877836847243 -1.3988914303667e-07 -0.09987648136325433 +2.432 0.7068890721909549 0.7068878510278243 -1.3929897390956014e-07 -0.09987651886275015 +2.4320999999999997 0.7068891374560355 0.7068879183441874 -1.3868679514701665e-07 -0.09987655635086844 +2.4322000000000004 0.706889202707843 0.7068879856335848 -1.380527545873783e-07 -0.09987659382761255 +2.4323 0.7068892679466164 0.7068880528957899 -1.373970050771306e-07 -0.09987663129298598 +2.4324 0.7068893331725934 0.7068881201305774 -1.3671970441019032e-07 -0.09987666874699215 +2.4325 0.7068893983860092 0.7068881873377242 -1.3602101531923205e-07 -0.09987670618963454 +2.4326 0.7068894635870975 0.7068882545170087 -1.3530110540976859e-07 -0.09987674362091654 +2.4327 0.7068895287760903 0.706888321668211 -1.3456014712892594e-07 -0.09987678104084165 +2.4328000000000003 0.7068895939532176 0.7068883887911139 -1.337983177307489e-07 -0.09987681844941332 +2.4329 0.7068896591187073 0.7068884558855009 -1.330157992328329e-07 -0.09987685584663492 +2.433 0.7068897242727853 0.7068885229511587 -1.3221277836254763e-07 -0.09987689323250992 +2.4331 0.7068897894156756 0.7068885899878754 -1.3138944651540363e-07 -0.09987693060704181 +2.4332000000000003 0.7068898545475999 0.7068886569954415 -1.3054599972209258e-07 -0.09987696797023399 +2.4333 0.706889919668778 0.7068887239736492 -1.2968263859297613e-07 -0.09987700532208985 +2.4334000000000002 0.7068899847794272 0.7068887909222936 -1.2879956826084005e-07 -0.0998770426626129 +2.4335 0.7068900498797626 0.7068888578411714 -1.2789699834793444e-07 -0.09987707999180646 +2.4335999999999998 0.706890114969997 0.7068889247300821 -1.2697514291046264e-07 -0.09987711730967412 +2.4337000000000004 0.7068901800503411 0.7068889915888275 -1.260342203900089e-07 -0.09987715461621921 +2.4338 0.7068902451210026 0.7068890584172114 -1.2507445354761892e-07 -0.09987719191144517 +2.4339 0.7068903101821874 0.7068891252150404 -1.2409606944298324e-07 -0.09987722919535544 +2.434 0.7068903752340989 0.7068891919821236 -1.2309929933382313e-07 -0.09987726646795349 +2.4341 0.7068904402769376 0.7068892587182722 -1.2208437867762545e-07 -0.0998773037292427 +2.4342 0.7068905053109013 0.7068893254233007 -1.210515470310286e-07 -0.09987734097922651 +2.4343000000000004 0.7068905703361852 0.7068893920970257 -1.2000104800298506e-07 -0.09987737821790835 +2.4344 0.7068906353529826 0.7068894587392667 -1.1893312920792376e-07 -0.09987741544529168 +2.4345 0.7068907003614833 0.7068895253498453 -1.1784804221023903e-07 -0.09987745266137985 +2.4346 0.7068907653618741 0.7068895919285868 -1.1674604245837106e-07 -0.0998774898661763 +2.4347000000000003 0.7068908303543402 0.7068896584753187 -1.1562738920674331e-07 -0.09987752705968449 +2.4348 0.7068908953390629 0.7068897249898716 -1.144923454862723e-07 -0.0998775642419078 +2.4349000000000003 0.7068909603162208 0.7068897914720784 -1.1334117802977439e-07 -0.09987760141284963 +2.435 0.7068910252859903 0.7068898579217759 -1.1217415719737278e-07 -0.09987763857251354 +2.4351 0.7068910902485439 0.7068899243388032 -1.109915569296599e-07 -0.0998776757209028 +2.4352000000000005 0.7068911552040514 0.7068899907230022 -1.0979365468351265e-07 -0.09987771285802087 +2.4353000000000002 0.70689122015268 0.7068900570742179 -1.0858073135056046e-07 -0.09987774998387115 +2.4354 0.7068912850945936 0.7068901233922992 -1.073530712068782e-07 -0.0998777870984571 +2.4355 0.7068913500299527 0.7068901896770972 -1.0611096183232166e-07 -0.09987782420178214 +2.4356 0.7068914149589149 0.7068902559284658 -1.0485469406889408e-07 -0.09987786129384958 +2.4357 0.7068914798816348 0.7068903221462635 -1.0358456192099963e-07 -0.09987789837466295 +2.4358 0.7068915447982638 0.7068903883303506 -1.0230086251034054e-07 -0.09987793544422562 +2.4359 0.7068916097089493 0.7068904544805912 -1.0100389599351778e-07 -0.09987797250254095 +2.436 0.7068916746138367 0.7068905205968528 -9.969396549177473e-08 -0.0998780095496124 +2.4360999999999997 0.7068917395130674 0.7068905866790057 -9.837137703375132e-08 -0.0998780465854434 +2.4362000000000004 0.7068918044067791 0.7068906527269241 -9.703643947048257e-08 -0.0998780836100373 +2.4363 0.706891869295107 0.7068907187404851 -9.568946440514231e-08 -0.09987812062339751 +2.4364 0.7068919341781823 0.7068907847195695 -9.433076612885838e-08 -0.0998781576255275 +2.4365 0.7068919990561331 0.7068908506640611 -9.296066153310911e-08 -0.09987819461643058 +2.4366 0.7068920639290839 0.7068909165738475 -9.157947004814065e-08 -0.0998782315961102 +2.4367 0.7068921287971559 0.7068909824488196 -9.018751356924121e-08 -0.09987826856456977 +2.4368000000000003 0.7068921936604666 0.7068910482888721 -8.878511636827013e-08 -0.09987830552181269 +2.4369 0.7068922585191302 0.7068911140939025 -8.737260503294264e-08 -0.0998783424678423 +2.437 0.7068923233732571 0.7068911798638127 -8.59503083800936e-08 -0.09987837940266209 +2.4371 0.7068923882229543 0.7068912455985075 -8.451855738975805e-08 -0.09987841632627542 +2.4372000000000003 0.7068924530683254 0.7068913112978955 -8.307768511670033e-08 -0.09987845323868566 +2.4373 0.7068925179094702 0.7068913769618892 -8.162802662102508e-08 -0.09987849013989625 +2.4374000000000002 0.7068925827464846 0.7068914425904038 -8.016991888664532e-08 -0.09987852702991054 +2.4375 0.7068926475794612 0.7068915081833594 -7.870370074408717e-08 -0.09987856390873195 +2.4375999999999998 0.7068927124084892 0.7068915737406788 -7.722971279676416e-08 -0.09987860077636382 +2.4377000000000004 0.7068927772336535 0.7068916392622888 -7.57482973307716e-08 -0.09987863763280963 +2.4378 0.7068928420550358 0.7068917047481202 -7.425979824072712e-08 -0.09987867447807271 +2.4379 0.7068929068727137 0.7068917701981068 -7.276456095734601e-08 -0.09987871131215643 +2.438 0.7068929716867615 0.7068918356121867 -7.126293235419981e-08 -0.09987874813506425 +2.4381 0.7068930364972492 0.7068919009903015 -6.975526067745999e-08 -0.09987878494679951 +2.4382 0.7068931013042435 0.7068919663323968 -6.82418954617639e-08 -0.09987882174736556 +2.4383000000000004 0.7068931661078074 0.7068920316384217 -6.67231874473817e-08 -0.09987885853676587 +2.4384 0.7068932309079995 0.7068920969083294 -6.519948850302118e-08 -0.09987889531500378 +2.4385 0.7068932957048752 0.7068921621420765 -6.367115153909156e-08 -0.0998789320820827 +2.4386 0.706893360498486 0.7068922273396234 -6.2138530430942e-08 -0.09987896883800593 +2.4387000000000003 0.7068934252888794 0.7068922925009347 -6.06019799351612e-08 -0.09987900558277696 +2.4388 0.706893490076099 0.7068923576259785 -5.906185560414223e-08 -0.09987904231639906 +2.4389000000000003 0.7068935548601853 0.7068924227147266 -5.751851370997159e-08 -0.0998790790388757 +2.439 0.7068936196411737 0.7068924877671554 -5.59723111572593e-08 -0.09987911575021025 +2.4391 0.706893684419097 0.7068925527832441 -5.4423605402257463e-08 -0.09987915245040602 +2.4392000000000005 0.7068937491939833 0.7068926177629766 -5.2872754373279804e-08 -0.09987918913946647 +2.4393000000000002 0.7068938139658572 0.70689268270634 -5.1320116382664455e-08 -0.0998792258173949 +2.4394 0.7068938787347394 0.7068927476133257 -4.97660500460009e-08 -0.09987926248419472 +2.4395 0.7068939435006467 0.7068928124839284 -4.8210914199839014e-08 -0.09987929913986926 +2.4396 0.7068940082635924 0.7068928773181478 -4.665506782145813e-08 -0.09987933578442196 +2.4397 0.7068940730235853 0.7068929421159862 -4.50988699402877e-08 -0.09987937241785617 +2.4398 0.706894137780631 0.7068930068774502 -4.3542679559221325e-08 -0.09987940904017527 +2.4399 0.7068942025347308 0.7068930716025502 -4.19868555711874e-08 -0.09987944565138256 +2.44 0.7068942672858822 0.7068931362913009 -4.0431756675719755e-08 -0.09987948225148147 +2.4400999999999997 0.7068943320340789 0.7068932009437202 -3.887774129669383e-08 -0.09987951884047536 +2.4402000000000004 0.7068943967793109 0.7068932655598303 -3.732516749995439e-08 -0.09987955541836757 +2.4403 0.706894461521564 0.706893330139657 -3.577439291069934e-08 -0.09987959198516144 +2.4404 0.7068945262608206 0.7068933946832302 -3.422577462945404e-08 -0.09987962854086042 +2.4405 0.7068945909970589 0.7068934591905831 -3.2679669152409566e-08 -0.09987966508546779 +2.4406 0.7068946557302537 0.7068935236617534 -3.113643228837282e-08 -0.09987970161898696 +2.4407 0.7068947204603754 0.706893588096782 -2.959641907810187e-08 -0.09987973814142126 +2.4408000000000003 0.7068947851873912 0.7068936524957141 -2.8059983709846636e-08 -0.09987977465277409 +2.4409 0.7068948499112642 0.7068937168585983 -2.6527479439226315e-08 -0.09987981115304877 +2.441 0.7068949146319536 0.7068937811854872 -2.499925851008264e-08 -0.09987984764224869 +2.4411 0.706894979349415 0.7068938454764372 -2.3475672070345788e-08 -0.09987988412037718 +2.4412000000000003 0.7068950440636005 0.706893909731508 -2.1957070093971826e-08 -0.0998799205874376 +2.4413 0.7068951087744577 0.7068939739507636 -2.044380129854334e-08 -0.09987995704343328 +2.4414000000000002 0.7068951734819313 0.7068940381342717 -1.8936213065038482e-08 -0.09987999348836762 +2.4415 0.7068952381859619 0.7068941022821034 -1.7434651364972575e-08 -0.09988002992224394 +2.4415999999999998 0.7068953028864865 0.7068941663943334 -1.5939460665855693e-08 -0.09988006634506563 +2.4417000000000004 0.7068953675834381 0.7068942304710408 -1.4450983871344691e-08 -0.09988010275683601 +2.4418 0.7068954322767462 0.7068942945123078 -1.296956222843551e-08 -0.09988013915755843 +2.4419 0.7068954969663372 0.7068943585182198 -1.1495535251569017e-08 -0.09988017554723626 +2.442 0.7068955616521329 0.7068944224888669 -1.00292406502063e-08 -0.09988021192587278 +2.4421 0.7068956263340525 0.7068944864243418 -8.57101424642931e-09 -0.09988024829347142 +2.4422 0.7068956910120107 0.7068945503247416 -7.121189903383507e-09 -0.09988028465003551 +2.4423000000000004 0.706895755685919 0.7068946141901664 -5.680099443745867e-09 -0.09988032099556832 +2.4424 0.7068958203556859 0.7068946780207199 -4.248072572529682e-09 -0.09988035733007325 +2.4425 0.7068958850212155 0.7068947418165095 -2.8254368063945767e-09 -0.09988039365355365 +2.4426 0.706895949682409 0.7068948055776463 -1.4125174016554887e-09 -0.09988042996601285 +2.4427000000000003 0.706896014339164 0.7068948693042443 -9.637268413853484e-12 -0.09988046626745423 +2.4428 0.7068960789913746 0.706894932996421 1.3828830910250778e-09 -0.09988050255788106 +2.4429000000000003 0.7068961436389314 0.7068949966542977 2.764725663684242e-09 -0.09988053883729667 +2.443 0.7068962082817215 0.7068950602779991 4.13557499356898e-09 -0.09988057510570444 +2.4431 0.7068962729196292 0.7068951238676529 5.495118259729592e-09 -0.0998806113631077 +2.4432000000000005 0.706896337552535 0.7068951874233902 6.843045335241937e-09 -0.09988064760950979 +2.4433000000000002 0.7068964021803161 0.7068952509453457 8.179048871341521e-09 -0.09988068384491403 +2.4434 0.706896466802847 0.7068953144336569 9.502824362475626e-09 -0.0998807200693238 +2.4435 0.706896531419998 0.7068953778884652 1.0814070209620719e-08 -0.09988075628274236 +2.4436 0.7068965960316369 0.7068954413099141 1.2112487808753347e-08 -0.09988079248517306 +2.4437 0.7068966606376283 0.7068955046981515 1.339778159074878e-08 -0.09988082867661928 +2.4438 0.7068967252378335 0.7068955680533278 1.4669659105515098e-08 -0.09988086485708432 +2.4439 0.7068967898321104 0.7068956313755961 1.592783108704532e-08 -0.09988090102657149 +2.444 0.7068968544203142 0.7068956946651135 1.7172011519336894e-08 -0.09988093718508408 +2.4440999999999997 0.7068969190022973 0.7068957579220397 1.8401917696239667e-08 -0.09988097333262552 +2.4442000000000004 0.7068969835779086 0.7068958211465373 1.9617270293446898e-08 -0.09988100946919906 +2.4443 0.7068970481469943 0.7068958843387716 2.081779342227169e-08 -0.09988104559480804 +2.4444 0.7068971127093975 0.7068959474989114 2.200321470684219e-08 -0.09988108170945575 +2.4445 0.7068971772649586 0.7068960106271283 2.3173265320530767e-08 -0.0998811178131456 +2.4446 0.7068972418135153 0.7068960737235961 2.432768008049646e-08 -0.09988115390588084 +2.4447 0.7068973063549024 0.7068961367884921 2.546619747890999e-08 -0.0998811899876648 +2.4448000000000003 0.7068973708889514 0.706896199821996 2.658855975667951e-08 -0.09988122605850082 +2.4449 0.7068974354154919 0.7068962628242905 2.769451296069647e-08 -0.09988126211839221 +2.445 0.70689749993435 0.7068963257955608 2.878380700108152e-08 -0.09988129816734226 +2.4451 0.7068975644453499 0.7068963887359945 2.985619569108311e-08 -0.09988133420535428 +2.4452000000000003 0.7068976289483131 0.7068964516457825 3.091143683034425e-08 -0.09988137023243168 +2.4453 0.7068976934430579 0.7068965145251175 3.1949292251740036e-08 -0.09988140624857769 +2.4454000000000002 0.7068977579294007 0.7068965773741949 3.296952786127627e-08 -0.09988144225379564 +2.4455 0.7068978224071554 0.7068966401932126 3.397191368839647e-08 -0.09988147824808884 +2.4455999999999998 0.7068978868761331 0.7068967029823714 3.4956223972718026e-08 -0.09988151423146058 +2.4457000000000004 0.7068979513361429 0.7068967657418735 3.592223716923637e-08 -0.09988155020391419 +2.4458 0.7068980157869915 0.7068968284719244 3.686973603332644e-08 -0.099881586165453 +2.4459 0.7068980802284832 0.7068968911727312 3.779850765543713e-08 -0.09988162211608029 +2.446 0.7068981446604201 0.7068969538445036 3.870834350098995e-08 -0.09988165805579935 +2.4461 0.7068982090826024 0.7068970164874533 3.959903947109433e-08 -0.09988169398461355 +2.4462 0.7068982734948275 0.7068970791017941 4.0470395940711557e-08 -0.09988172990252614 +2.4463000000000004 0.7068983378968914 0.7068971416877422 4.132221781243117e-08 -0.09988176580954042 +2.4464 0.7068984022885877 0.7068972042455153 4.215431453902241e-08 -0.09988180170565972 +2.4465 0.7068984666697082 0.7068972667753337 4.296650019455783e-08 -0.09988183759088737 +2.4466 0.7068985310400425 0.7068973292774194 4.375859349696476e-08 -0.09988187346522664 +2.4467000000000003 0.7068985953993785 0.706897391751996 4.453041784618916e-08 -0.09988190932868081 +2.4468 0.7068986597475021 0.7068974541992892 4.528180137797211e-08 -0.09988194518125319 +2.4469000000000003 0.7068987240841977 0.7068975166195265 4.601257698813588e-08 -0.0998819810229471 +2.447 0.7068987884092478 0.7068975790129369 4.672258238115623e-08 -0.0998820168537658 +2.4471 0.706898852722433 0.7068976413797515 4.741166010138742e-08 -0.0998820526737126 +2.4472000000000005 0.7068989170235327 0.7068977037202026 4.807965756081778e-08 -0.09988208848279079 +2.4473000000000003 0.7068989813123243 0.7068977660345244 4.872642708417252e-08 -0.09988212428100368 +2.4474 0.706899045588584 0.7068978283229523 4.935182593840404e-08 -0.09988216006835454 +2.4475 0.7068991098520863 0.7068978905857237 4.9955716353508595e-08 -0.0998821958448467 +2.4476 0.7068991741026045 0.7068979528230771 5.053796556762913e-08 -0.09988223161048346 +2.4477 0.7068992383399102 0.7068980150352517 5.109844585828027e-08 -0.09988226736526801 +2.4478 0.706899302563774 0.7068980772224893 5.163703454755253e-08 -0.09988230310920372 +2.4479 0.7068993667739651 0.706898139385032 5.215361405068453e-08 -0.09988233884229386 +2.448 0.7068994309702519 0.7068982015231235 5.264807189167553e-08 -0.09988237456454177 +2.4480999999999997 0.7068994951524008 0.7068982636370086 5.312030073797991e-08 -0.09988241027595067 +2.4482000000000004 0.7068995593201779 0.7068983257269328 5.3570198402241864e-08 -0.09988244597652385 +2.4483 0.706899623473348 0.7068983877931432 5.399766788739824e-08 -0.0998824816662646 +2.4484 0.7068996876116747 0.7068984498358877 5.4402617409229914e-08 -0.09988251734517622 +2.4485 0.7068997517349208 0.7068985118554147 5.4784960385953485e-08 -0.09988255301326196 +2.4486 0.7068998158428486 0.7068985738519744 5.5144615472915715e-08 -0.09988258867052513 +2.4487 0.7068998799352189 0.7068986358258169 5.548150660596163e-08 -0.09988262431696904 +2.4488000000000003 0.7068999440117925 0.7068986977771934 5.5795562968474766e-08 -0.09988265995259693 +2.4489 0.7069000080723289 0.7068987597063555 5.608671905382723e-08 -0.09988269557741203 +2.449 0.7069000721165876 0.7068988216135561 5.6354914641093545e-08 -0.09988273119141773 +2.4491 0.7069001361443266 0.7068988834990482 5.660009482974515e-08 -0.09988276679461723 +2.4492000000000003 0.7069002001553043 0.7068989453630852 5.682221004658927e-08 -0.09988280238701383 +2.4493 0.7069002641492781 0.7068990072059214 5.702121604056476e-08 -0.0998828379686108 +2.4494000000000002 0.7069003281260049 0.7068990690278107 5.719707391223239e-08 -0.09988287353941135 +2.4495 0.7069003920852416 0.7068991308290086 5.734975011550958e-08 -0.09988290909941883 +2.4495999999999998 0.7069004560267447 0.7068991926097702 5.747921645593568e-08 -0.0998829446486365 +2.4497000000000004 0.7069005199502703 0.7068992543703505 5.758545009934557e-08 -0.09988298018706762 +2.4498 0.7069005838555746 0.7068993161110052 5.7668433584012746e-08 -0.09988301571471547 +2.4499 0.7069006477424137 0.7068993778319896 5.7728154806771514e-08 -0.09988305123158327 +2.45 0.7069007116105432 0.7068994395335599 5.776460703862951e-08 -0.09988308673767433 +2.4501 0.706900775459719 0.7068995012159716 5.777778891435936e-08 -0.09988312223299195 +2.4502 0.7069008392896969 0.7068995628794803 5.776770443943757e-08 -0.0998831577175393 +2.4503000000000004 0.7069009031002332 0.7068996245243415 5.773436298137091e-08 -0.09988319319131975 +2.4504 0.7069009668910838 0.7068996861508109 5.767777927663531e-08 -0.09988322865433649 +2.4505 0.7069010306620052 0.7068997477591432 5.759797340812445e-08 -0.09988326410659279 +2.4506 0.7069010944127541 0.7068998093495936 5.7494970813823376e-08 -0.09988329954809194 +2.4507000000000003 0.7069011581430875 0.7068998709224166 5.736880226946128e-08 -0.09988333497883721 +2.4508 0.7069012218527629 0.7068999324778662 5.721950388330732e-08 -0.09988337039883183 +2.4509000000000003 0.7069012855415379 0.706899994016196 5.7047117094435884e-08 -0.099883405808079 +2.451 0.7069013492091711 0.7069000555376592 5.685168864844048e-08 -0.0998834412065821 +2.4511 0.7069014128554214 0.7069001170425084 5.663327059396428e-08 -0.09988347659434428 +2.4512000000000005 0.7069014764800483 0.7069001785309956 5.639192026361817e-08 -0.09988351197136885 +2.4513000000000003 0.7069015400828121 0.7069002400033721 5.612770026357239e-08 -0.09988354733765906 +2.4514 0.7069016036634739 0.7069003014598886 5.5840678451005155e-08 -0.09988358269321818 +2.4515 0.7069016672217951 0.7069003629007946 5.5530927923694295e-08 -0.09988361803804943 +2.4516 0.7069017307575388 0.7069004243263389 5.519852700440475e-08 -0.09988365337215609 +2.4517 0.7069017942704683 0.7069004857367698 5.484355920966355e-08 -0.09988368869554139 +2.4518 0.706901857760348 0.7069005471323342 5.4466113234147295e-08 -0.09988372400820858 +2.4519 0.7069019212269433 0.7069006085132779 5.4066282940273824e-08 -0.09988375931016089 +2.452 0.7069019846700209 0.7069006698798459 5.364416730789523e-08 -0.09988379460140157 +2.4520999999999997 0.7069020480893486 0.7069007312322823 5.319987044123675e-08 -0.09988382988193392 +2.4522000000000004 0.7069021114846954 0.7069007925708292 5.2733501522059245e-08 -0.09988386515176112 +2.4523 0.7069021748558308 0.7069008538957283 5.2245174788842497e-08 -0.09988390041088642 +2.4524 0.7069022382025267 0.70690091520722 5.17350095124991e-08 -0.09988393565931314 +2.4525 0.7069023015245559 0.7069009765055427 5.120312996167997e-08 -0.09988397089704451 +2.4526 0.7069023648216921 0.7069010377909337 5.06496653819577e-08 -0.09988400612408366 +2.4527 0.7069024280937114 0.7069010990636289 5.007474995419314e-08 -0.09988404134043395 +2.4528000000000003 0.7069024913403905 0.7069011603238626 4.947852275810627e-08 -0.09988407654609854 +2.4529 0.706902554561508 0.706901221571868 4.88611277549289e-08 -0.0998841117410807 +2.453 0.7069026177568443 0.706901282807876 4.822271373883247e-08 -0.09988414692538364 +2.4531 0.7069026809261811 0.7069013440321162 4.7563434319580766e-08 -0.09988418209901065 +2.4532000000000003 0.7069027440693023 0.7069014052448167 4.688344785661047e-08 -0.09988421726196496 +2.4533 0.7069028071859932 0.7069014664462032 4.618291744515335e-08 -0.09988425241424977 +2.4534000000000002 0.7069028702760407 0.7069015276365005 4.546201086939872e-08 -0.09988428755586831 +2.4535 0.706902933339234 0.7069015888159307 4.472090055739064e-08 -0.09988432268682387 +2.4536 0.7069029963753641 0.7069016499847143 4.395976354459874e-08 -0.09988435780711963 +2.4537000000000004 0.7069030593842237 0.7069017111430698 4.317878143748899e-08 -0.09988439291675882 +2.4538 0.7069031223656079 0.7069017722912139 4.2378140368420913e-08 -0.09988442801574471 +2.4539 0.7069031853193135 0.7069018334293611 4.1558030929728096e-08 -0.0998844631040805 +2.454 0.7069032482451394 0.7069018945577237 4.071864815984039e-08 -0.09988449818176938 +2.4541 0.7069033111428873 0.7069019556765118 3.986019147909914e-08 -0.09988453324881466 +2.4542 0.70690337401236 0.7069020167859337 3.898286464812384e-08 -0.09988456830521952 +2.4543000000000004 0.7069034368533635 0.706902077886195 3.808687571750513e-08 -0.09988460335098719 +2.4544 0.7069034996657055 0.7069021389774992 3.717243697923256e-08 -0.09988463838612086 +2.4545 0.7069035624491964 0.7069022000600476 3.623976491812231e-08 -0.0998846734106238 +2.4546 0.7069036252036487 0.706902261134039 3.528908015630605e-08 -0.09988470842449923 +2.4547000000000003 0.7069036879288773 0.7069023221996695 3.432060739945453e-08 -0.09988474342775033 +2.4548 0.7069037506247 0.7069023832571334 3.333457539340945e-08 -0.09988477842038036 +2.4549000000000003 0.7069038132909367 0.7069024443066217 3.233121685826401e-08 -0.09988481340239252 +2.455 0.7069038759274098 0.7069025053483238 3.131076844152536e-08 -0.09988484837379007 +2.4551 0.7069039385339444 0.7069025663824255 3.027347067127706e-08 -0.09988488333457617 +2.4552000000000005 0.7069040011103684 0.7069026274091106 2.921956787464708e-08 -0.09988491828475404 +2.4553000000000003 0.7069040636565125 0.70690268842856 2.814930814311334e-08 -0.09988495322432697 +2.4554 0.7069041261722093 0.7069027494409517 2.7062943261380035e-08 -0.09988498815329806 +2.4555 0.7069041886572951 0.7069028104464613 2.5960728653601217e-08 -0.09988502307167059 +2.4556 0.7069042511116085 0.7069028714452616 2.4842923326134914e-08 -0.09988505797944779 +2.4557 0.7069043135349908 0.7069029324375227 2.370978979295002e-08 -0.09988509287663283 +2.4558 0.7069043759272866 0.7069029934234115 2.256159403052349e-08 -0.09988512776322894 +2.4559 0.706904438288343 0.7069030544030916 2.139860540931876e-08 -0.09988516263923931 +2.456 0.7069045006180104 0.7069031153767249 2.0221096623529444e-08 -0.09988519750466723 +2.4560999999999997 0.7069045629161416 0.7069031763444691 1.9029343639904994e-08 -0.0998852323595158 +2.4562000000000004 0.7069046251825928 0.7069032373064794 1.78236256274944e-08 -0.09988526720378822 +2.4563 0.7069046874172235 0.7069032982629082 1.6604224883053076e-08 -0.09988530203748779 +2.4564 0.7069047496198955 0.7069033592139047 1.5371426784205333e-08 -0.09988533686061762 +2.4565 0.7069048117904746 0.7069034201596142 1.4125519709647094e-08 -0.09988537167318096 +2.4566 0.7069048739288292 0.7069034811001802 1.2866794962818062e-08 -0.09988540647518102 +2.4567 0.706904936034831 0.7069035420357422 1.1595546732003081e-08 -0.09988544126662104 +2.4568000000000003 0.7069049981083544 0.7069036029664367 1.0312071996657068e-08 -0.09988547604750414 +2.4569 0.706905060149278 0.7069036638923967 9.01667046582233e-09 -0.09988551081783353 +2.457 0.7069051221574829 0.7069037248137526 7.709644503535451e-09 -0.09988554557761244 +2.4571 0.7069051841328537 0.706903785730631 6.3912990776529566e-09 -0.09988558032684408 +2.4572000000000003 0.7069052460752785 0.7069038466431552 5.061941663574154e-09 -0.09988561506553165 +2.4573 0.7069053079846482 0.7069039075514453 3.7218821826584536e-09 -0.0998856497936783 +2.4574000000000003 0.7069053698608578 0.706903968455618 2.3714329311017024e-09 -0.09988568451128725 +2.4575 0.7069054317038048 0.7069040293557868 1.0109085131493334e-09 -0.09988571921836169 +2.4576000000000002 0.7069054935133909 0.7069040902520614 -3.593742395682775e-10 -0.09988575391490483 +2.4577000000000004 0.7069055552895207 0.7069041511445485 -1.7390963513025381e-09 -0.09988578860091982 +2.4578 0.7069056170321026 0.706904212033351 -3.1279367507588973e-09 -0.0998858232764099 +2.4579 0.7069056787410484 0.7069042729185683 -4.525572372578168e-09 -0.0998858579413782 +2.458 0.7069057404162732 0.7069043338002968 -5.93167821805185e-09 -0.09988589259582797 +2.4581000000000004 0.7069058020576959 0.7069043946786291 -7.3459274271131525e-09 -0.09988592723976242 +2.4582 0.7069058636652383 0.7069044555536538 -8.767991366807892e-09 -0.09988596187318464 +2.4583000000000004 0.7069059252388268 0.7069045164254564 -1.0197539700683433e-08 -0.09988599649609786 +2.4584 0.7069059867783904 0.7069045772941194 -1.1634240463815476e-08 -0.0998860311085053 +2.4585 0.706906048283862 0.7069046381597206 -1.3077760143039019e-08 -0.09988606571041012 +2.4586000000000006 0.7069061097551783 0.7069046990223349 -1.4527763755444595e-08 -0.09988610030181545 +2.4587000000000003 0.7069061711922796 0.706904759882033 -1.5983914920802977e-08 -0.09988613488272455 +2.4588 0.7069062325951097 0.706904820738883 -1.744587594700031e-08 -0.0998861694531406 +2.4589000000000003 0.7069062939636157 0.7069048815929483 -1.891330789899337e-08 -0.09988620401306673 +2.459 0.706906355297749 0.7069049424442891 -2.0385870685545732e-08 -0.09988623856250617 +2.4591000000000003 0.7069064165974642 0.706905003292962 -2.186322313598929e-08 -0.09988627310146202 +2.4592 0.7069064778627199 0.7069050641390198 -2.334502307611841e-08 -0.09988630762993753 +2.4593000000000003 0.706906539093478 0.7069051249825116 -2.483092741145665e-08 -0.09988634214793585 +2.4594 0.7069066002897042 0.7069051858234827 -2.6320592201849874e-08 -0.09988637665546013 +2.4595 0.7069066614513685 0.706905246661975 -2.7813672747768747e-08 -0.09988641115251362 +2.4596000000000005 0.7069067225784438 0.7069053074980266 -2.9309823662950277e-08 -0.09988644563909943 +2.4597 0.7069067836709071 0.7069053683316715 -3.080869895831506e-08 -0.09988648011522076 +2.4598 0.706906844728739 0.7069054291629406 -3.23099521234993e-08 -0.09988651458088077 +2.4599 0.7069069057519239 0.7069054899918608 -3.3813236202315244e-08 -0.09988654903608266 +2.46 0.7069069667404501 0.7069055508184546 -3.531820387493376e-08 -0.09988658348082956 +2.4601 0.7069070276943092 0.7069056116427419 -3.682450753887418e-08 -0.09988661791512465 +2.4602000000000004 0.7069070886134966 0.7069056724647382 -3.83317993907532e-08 -0.0998866523389711 +2.4603 0.7069071494980121 0.7069057332844555 -3.9839731500715316e-08 -0.09988668675237208 +2.4604 0.7069072103478586 0.7069057941019017 -4.134795589911481e-08 -0.09988672115533076 +2.4605 0.7069072711630426 0.7069058549170812 -4.2856124654144616e-08 -0.09988675554785026 +2.4606000000000003 0.706907331943575 0.7069059157299953 -4.436388995143032e-08 -0.09988678992993384 +2.4607 0.7069073926894698 0.7069059765406404 -4.587090417503361e-08 -0.09988682430158462 +2.4608000000000003 0.7069074534007449 0.7069060373490095 -4.737681998741219e-08 -0.09988685866280567 +2.4609 0.7069075140774222 0.7069060981550926 -4.8881290409244146e-08 -0.09988689301360028 +2.461 0.706907574719527 0.7069061589588753 -5.038396889978092e-08 -0.09988692735397153 +2.4611000000000005 0.7069076353270886 0.7069062197603397 -5.1884509436658094e-08 -0.09988696168392264 +2.4612000000000003 0.7069076959001397 0.7069062805594638 -5.3382566595665606e-08 -0.09988699600345669 +2.4613 0.706907756438717 0.7069063413562228 -5.48777956289187e-08 -0.09988703031257695 +2.4614000000000003 0.7069078169428604 0.7069064021505871 -5.6369852545739424e-08 -0.09988706461128648 +2.4615 0.7069078774126142 0.7069064629425243 -5.785839419202021e-08 -0.09988709889958847 +2.4616000000000002 0.7069079378480256 0.7069065237319978 -5.934307832698542e-08 -0.09988713317748604 +2.4617000000000004 0.7069079982491463 0.7069065845189677 -6.082356370168754e-08 -0.09988716744498242 +2.4618 0.7069080586160309 0.7069066453033899 -6.229951014140658e-08 -0.0998872017020807 +2.4619 0.7069081189487377 0.7069067060852173 -6.377057862111055e-08 -0.09988723594878399 +2.462 0.7069081792473296 0.7069067668643989 -6.523643134026536e-08 -0.09988727018509558 +2.4621000000000004 0.7069082395118718 0.7069068276408799 -6.669673180805316e-08 -0.0998873044110185 +2.4622 0.7069082997424335 0.7069068884146024 -6.815114491492968e-08 -0.09988733862655591 +2.4623000000000004 0.7069083599390882 0.7069069491855043 -6.9599337007651e-08 -0.09988737283171102 +2.4624 0.706908420101912 0.7069070099535206 -7.104097596907083e-08 -0.09988740702648696 +2.4625 0.7069084802309852 0.7069070707185818 -7.247573129663676e-08 -0.09988744121088683 +2.4626000000000006 0.7069085403263912 0.7069071314806157 -7.390327417524864e-08 -0.09988747538491377 +2.4627000000000003 0.7069086003882172 0.7069071922395467 -7.532327754968329e-08 -0.09988750954857102 +2.4628 0.7069086604165538 0.7069072529952949 -7.673541620525914e-08 -0.09988754370186165 +2.4629000000000003 0.706908720411495 0.7069073137477774 -7.813936683982725e-08 -0.09988757784478879 +2.463 0.7069087803731382 0.706907374496908 -7.953480813532865e-08 -0.09988761197735559 +2.4631000000000003 0.7069088403015844 0.706907435242597 -8.09214208358569e-08 -0.09988764609956524 +2.4632 0.706908900196938 0.7069074959847509 -8.229888781748074e-08 -0.09988768021142085 +2.4633000000000003 0.7069089600593066 0.7069075567232733 -8.366689415763295e-08 -0.09988771431292554 +2.4634 0.7069090198888013 0.7069076174580642 -8.502512721837718e-08 -0.09988774840408243 +2.4635 0.7069090796855364 0.7069076781890203 -8.637327670365375e-08 -0.09988778248489472 +2.4636000000000005 0.7069091394496294 0.7069077389160352 -8.771103474254638e-08 -0.09988781655536548 +2.4637000000000002 0.7069091991812015 0.7069077996389989 -8.903809595346701e-08 -0.09988785061549786 +2.4638 0.7069092588803769 0.7069078603577982 -9.035415750573844e-08 -0.09988788466529502 +2.4639 0.706909318547283 0.7069079210723168 -9.165891920719788e-08 -0.09988791870476009 +2.464 0.7069093781820504 0.7069079817824355 -9.295208356057544e-08 -0.09988795273389622 +2.4641 0.7069094377848126 0.7069080424880315 -9.423335582941367e-08 -0.0998879867527065 +2.4642000000000004 0.706909497355707 0.7069081031889788 -9.55024441109259e-08 -0.09988802076119406 +2.4643 0.7069095568948729 0.7069081638851485 -9.67590594010484e-08 -0.09988805475936204 +2.4644 0.7069096164024539 0.7069082245764087 -9.800291566122721e-08 -0.09988808874721355 +2.4645 0.7069096758785958 0.7069082852626245 -9.923372988000084e-08 -0.09988812272475177 +2.4646000000000003 0.7069097353234479 0.7069083459436578 -1.004512221449913e-07 -0.09988815669197981 +2.4647 0.7069097947371622 0.7069084066193676 -1.0165511569321106e-07 -0.09988819064890075 +2.4648000000000003 0.7069098541198935 0.7069084672896098 -1.028451369873909e-07 -0.09988822459551772 +2.4649 0.7069099134717999 0.7069085279542378 -1.040210157654195e-07 -0.09988825853183389 +2.465 0.7069099727930419 0.7069085886131019 -1.0518248512014078e-07 -0.09988829245785236 +2.4651000000000005 0.7069100320837832 0.7069086492660497 -1.0632928153925247e-07 -0.09988832637357627 +2.4652000000000003 0.7069100913441901 0.7069087099129255 -1.0746114497556247e-07 -0.09988836027900867 +2.4653 0.7069101505744317 0.7069087705535717 -1.0857781890249996e-07 -0.09988839417415277 +2.4654000000000003 0.70691020977468 0.7069088311878272 -1.0967905038176962e-07 -0.0998884280590116 +2.4655 0.7069102689451092 0.7069088918155285 -1.10764590114526e-07 -0.09988846193358836 +2.4656000000000002 0.7069103280858965 0.70690895243651 -1.1183419248821103e-07 -0.09988849579788611 +2.4657000000000004 0.7069103871972217 0.7069090130506028 -1.1288761564247352e-07 -0.09988852965190803 +2.4658 0.7069104462792666 0.7069090736576358 -1.1392462152121086e-07 -0.09988856349565718 +2.4659 0.7069105053322164 0.706909134257435 -1.1494497592634545e-07 -0.09988859732913664 +2.466 0.7069105643562581 0.7069091948498244 -1.1594844857507058e-07 -0.09988863115234961 +2.4661000000000004 0.7069106233515814 0.7069092554346255 -1.1693481314668797e-07 -0.09988866496529919 +2.4662 0.7069106823183784 0.7069093160116566 -1.179038473329147e-07 -0.09988869876798837 +2.4663000000000004 0.7069107412568433 0.7069093765807353 -1.1885533288645556e-07 -0.09988873256042041 +2.4664 0.7069108001671728 0.7069094371416755 -1.197890556765141e-07 -0.09988876634259834 +2.4665 0.7069108590495656 0.7069094976942891 -1.2070480574083442e-07 -0.09988880011452526 +2.4666000000000006 0.7069109179042232 0.7069095582383865 -1.2160237731866086e-07 -0.09988883387620434 +2.4667000000000003 0.7069109767313486 0.7069096187737752 -1.2248156889757555e-07 -0.09988886762763866 +2.4668 0.7069110355311472 0.7069096793002609 -1.2334218328635682e-07 -0.0998889013688313 +2.4669 0.7069110943038261 0.7069097398176472 -1.2418402761324443e-07 -0.09988893509978536 +2.467 0.7069111530495951 0.7069098003257356 -1.2500691340400216e-07 -0.09988896882050396 +2.4671000000000003 0.7069112117686656 0.7069098608243258 -1.2581065662181645e-07 -0.09988900253099027 +2.4672 0.7069112704612506 0.7069099213132154 -1.2659507769505196e-07 -0.0998890362312473 +2.4673000000000003 0.7069113291275654 0.7069099817921999 -1.2736000155368077e-07 -0.0998890699212781 +2.4674 0.7069113877678275 0.7069100422610735 -1.2810525768479353e-07 -0.09988910360108594 +2.4675 0.706911446382255 0.7069101027196284 -1.2883068016902866e-07 -0.09988913727067379 +2.4676000000000005 0.7069115049710686 0.7069101631676551 -1.2953610769791957e-07 -0.09988917093004476 +2.4677000000000002 0.7069115635344905 0.7069102236049425 -1.302213836484878e-07 -0.099889204579202 +2.4678 0.7069116220727447 0.7069102840312775 -1.3088635606069154e-07 -0.09988923821814857 +2.4679 0.7069116805860566 0.7069103444464457 -1.3153087771895777e-07 -0.0998892718468876 +2.468 0.7069117390746527 0.7069104048502313 -1.321548061729988e-07 -0.09988930546542213 +2.4681 0.7069117975387615 0.7069104652424167 -1.3275800375689428e-07 -0.09988933907375526 +2.4682000000000004 0.706911855978613 0.7069105256227834 -1.3334033763072461e-07 -0.09988937267189012 +2.4683 0.7069119143944381 0.7069105859911111 -1.3390167981006118e-07 -0.09988940625982978 +2.4684 0.7069119727864694 0.7069106463471779 -1.3444190718851778e-07 -0.09988943983757732 +2.4685 0.7069120311549407 0.7069107066907614 -1.3496090156030205e-07 -0.09988947340513588 +2.4686000000000003 0.7069120895000867 0.7069107670216376 -1.3545854965837933e-07 -0.09988950696250848 +2.4687 0.7069121478221434 0.7069108273395812 -1.3593474317181997e-07 -0.09988954050969827 +2.4688000000000003 0.7069122061213482 0.7069108876443659 -1.3638937878222845e-07 -0.09988957404670826 +2.4689 0.7069122643979393 0.7069109479357647 -1.3682235815853927e-07 -0.0998896075735416 +2.469 0.7069123226521558 0.7069110082135491 -1.3723358799171137e-07 -0.09988964109020135 +2.4691000000000005 0.7069123808842377 0.70691106847749 -1.376229800346268e-07 -0.09988967459669057 +2.4692000000000003 0.7069124390944264 0.7069111287273571 -1.3799045109341712e-07 -0.09988970809301241 +2.4693 0.7069124972829637 0.7069111889629195 -1.383359230552189e-07 -0.09988974157916991 +2.4694000000000003 0.7069125554500919 0.7069112491839453 -1.3865932289684746e-07 -0.09988977505516614 +2.4695 0.7069126135960546 0.7069113093902023 -1.3896058272643008e-07 -0.09988980852100414 +2.4696000000000002 0.7069126717210958 0.7069113695814575 -1.392396397573853e-07 -0.0998898419766871 +2.4697000000000005 0.7069127298254605 0.7069114297574769 -1.3949643636219922e-07 -0.09988987542221807 +2.4698 0.7069127879093933 0.7069114899180262 -1.3973092005507837e-07 -0.09988990885760007 +2.4699 0.7069128459731401 0.7069115500628709 -1.399430435179705e-07 -0.09988994228283621 +2.47 0.7069129040169471 0.7069116101917754 -1.4013276459362567e-07 -0.09988997569792954 +2.4701000000000004 0.7069129620410604 0.7069116703045042 -1.4030004630814774e-07 -0.09989000910288316 +2.4702 0.7069130200457274 0.7069117304008214 -1.4044485688313735e-07 -0.09989004249770013 +2.4703000000000004 0.7069130780311949 0.7069117904804909 -1.405671697252836e-07 -0.09989007588238356 +2.4704 0.7069131359977103 0.7069118505432759 -1.4066696343677243e-07 -0.09989010925693648 +2.4705 0.7069131939455211 0.7069119105889399 -1.407442218256949e-07 -0.09989014262136194 +2.4706000000000006 0.7069132518748747 0.7069119706172463 -1.4079893389910836e-07 -0.09989017597566303 +2.4707000000000003 0.7069133097860192 0.7069120306279582 -1.408310938578322e-07 -0.09989020931984287 +2.4708 0.7069133676792021 0.7069120906208388 -1.4084070112593827e-07 -0.09989024265390449 +2.4709 0.706913425554671 0.7069121505956514 -1.4082776030564792e-07 -0.09989027597785095 +2.471 0.7069134834126729 0.7069122105521592 -1.407922812276391e-07 -0.0998903092916853 +2.4711000000000003 0.7069135412534557 0.7069122704901261 -1.407342788938004e-07 -0.09989034259541064 +2.4712 0.7069135990772665 0.7069123304093156 -1.4065377350325203e-07 -0.09989037588903005 +2.4713000000000003 0.7069136568843516 0.7069123903094916 -1.405507904349984e-07 -0.09989040917254653 +2.4714 0.7069137146749577 0.7069124501904189 -1.404253602566019e-07 -0.09989044244596318 +2.4715 0.7069137724493308 0.7069125100518622 -1.4027751868428417e-07 -0.09989047570928306 +2.4716000000000005 0.7069138302077167 0.7069125698935863 -1.4010730661415116e-07 -0.09989050896250923 +2.4717000000000002 0.7069138879503605 0.7069126297153574 -1.3991477007882502e-07 -0.09989054220564476 +2.4718 0.7069139456775066 0.7069126895169418 -1.396999602370358e-07 -0.0998905754386927 +2.4719 0.706914003389399 0.7069127492981058 -1.3946293338056026e-07 -0.09989060866165611 +2.472 0.7069140610862807 0.7069128090586176 -1.3920375090646642e-07 -0.09989064187453801 +2.4721 0.7069141187683948 0.706912868798245 -1.3892247931017454e-07 -0.0998906750773415 +2.4722000000000004 0.7069141764359826 0.7069129285167574 -1.3861919014382384e-07 -0.09989070827006963 +2.4723 0.7069142340892851 0.7069129882139245 -1.3829396002668082e-07 -0.09989074145272545 +2.4724 0.7069142917285426 0.7069130478895169 -1.3794687062432254e-07 -0.09989077462531198 +2.4725 0.706914349353994 0.7069131075433066 -1.3757800860006442e-07 -0.09989080778783235 +2.4726000000000004 0.7069144069658775 0.7069131671750664 -1.3718746562016437e-07 -0.09989084094028952 +2.4727 0.7069144645644296 0.7069132267845697 -1.3677533833127142e-07 -0.0998908740826866 +2.4728000000000003 0.7069145221498869 0.7069132863715916 -1.3634172831879232e-07 -0.0998909072150266 +2.4729 0.7069145797224843 0.7069133459359078 -1.3588674209301377e-07 -0.0998909403373126 +2.473 0.7069146372824551 0.7069134054772956 -1.3541049106828573e-07 -0.09989097344954767 +2.4731000000000005 0.7069146948300316 0.7069134649955336 -1.3491309152659225e-07 -0.09989100655173479 +2.4732000000000003 0.7069147523654449 0.7069135244904015 -1.3439466459326532e-07 -0.09989103964387706 +2.4733 0.7069148098889244 0.7069135839616802 -1.3385533620749457e-07 -0.09989107272597747 +2.4734000000000003 0.7069148674006989 0.7069136434091525 -1.3329523708242863e-07 -0.09989110579803911 +2.4735 0.7069149249009947 0.706913702832602 -1.3271450268956264e-07 -0.09989113886006501 +2.4736000000000002 0.7069149823900375 0.7069137622318146 -1.3211327322577848e-07 -0.09989117191205821 +2.4737000000000005 0.7069150398680507 0.7069138216065771 -1.3149169355262946e-07 -0.09989120495402176 +2.4738 0.7069150973352565 0.7069138809566786 -1.308499132032792e-07 -0.09989123798595873 +2.4739 0.7069151547918753 0.706913940281909 -1.301880863096433e-07 -0.0998912710078721 +2.474 0.7069152122381257 0.7069139995820604 -1.2950637159198086e-07 -0.09989130401976495 +2.4741000000000004 0.7069152696742249 0.7069140588569267 -1.288049323016488e-07 -0.09989133702164028 +2.4742 0.7069153271003876 0.7069141181063036 -1.2808393618640723e-07 -0.09989137001350115 +2.4743000000000004 0.7069153845168277 0.7069141773299882 -1.2734355546439868e-07 -0.09989140299535058 +2.4744 0.706915441923756 0.7069142365277803 -1.2658396675822858e-07 -0.09989143596719165 +2.4745 0.7069154993213822 0.7069142956994809 -1.258053510758833e-07 -0.09989146892902734 +2.4746000000000006 0.7069155567099137 0.7069143548448935 -1.2500789376215793e-07 -0.09989150188086071 +2.4747000000000003 0.7069156140895558 0.7069144139638234 -1.2419178445008394e-07 -0.09989153482269476 +2.4748 0.706915671460512 0.7069144730560779 -1.233572170106223e-07 -0.09989156775453259 +2.4749 0.7069157288229835 0.7069145321214668 -1.2250438951623421e-07 -0.09989160067637719 +2.475 0.7069157861771688 0.7069145911598017 -1.2163350419577834e-07 -0.09989163358823154 +2.4751000000000003 0.7069158435232649 0.7069146501708965 -1.2074476737899964e-07 -0.09989166649009873 +2.4752 0.7069159008614663 0.7069147091545678 -1.1983838944622238e-07 -0.09989169938198177 +2.4753000000000003 0.7069159581919651 0.7069147681106339 -1.1891458478498207e-07 -0.09989173226388372 +2.4754 0.7069160155149512 0.7069148270389157 -1.1797357173971845e-07 -0.09989176513580754 +2.4755 0.7069160728306118 0.7069148859392365 -1.1701557255279493e-07 -0.09989179799775627 +2.4756000000000005 0.7069161301391322 0.706914944811422 -1.1604081331939575e-07 -0.099891830849733 +2.4757000000000002 0.7069161874406948 0.7069150036553002 -1.1504952394242318e-07 -0.09989186369174068 +2.4758 0.7069162447354794 0.7069150624707021 -1.140419380492308e-07 -0.0998918965237823 +2.4759 0.7069163020236638 0.7069151212574611 -1.130182929638679e-07 -0.09989192934586104 +2.476 0.7069163593054226 0.706915180015413 -1.1197882964289474e-07 -0.0998919621579798 +2.4761 0.7069164165809281 0.7069152387443958 -1.1092379262507557e-07 -0.09989199496014159 +2.4762000000000004 0.7069164738503495 0.706915297444251 -1.0985342994984659e-07 -0.09989202775234945 +2.4763 0.706916531113854 0.7069153561148227 -1.087679931278257e-07 -0.09989206053460645 +2.4764 0.7069165883716053 0.7069154147559572 -1.0766773706708671e-07 -0.09989209330691552 +2.4765 0.706916645623765 0.7069154733675039 -1.0655292002198502e-07 -0.09989212606927973 +2.4766000000000004 0.7069167028704915 0.706915531949315 -1.0542380351943187e-07 -0.09989215882170205 +2.4767 0.7069167601119404 0.7069155905012456 -1.0428065230945471e-07 -0.09989219156418554 +2.4768000000000003 0.7069168173482645 0.7069156490231536 -1.031237342932062e-07 -0.0998922242967332 +2.4769 0.7069168745796135 0.7069157075149 -1.0195332048133082e-07 -0.09989225701934806 +2.477 0.7069169318061344 0.7069157659763482 -1.0076968489508564e-07 -0.0998922897320331 +2.4771000000000005 0.706916989027971 0.706915824407365 -9.957310453424795e-08 -0.09989232243479126 +2.4772000000000003 0.7069170462452641 0.7069158828078206 -9.836385929471586e-08 -0.09989235512762569 +2.4773 0.7069171034581516 0.7069159411775876 -9.714223191386456e-08 -0.09989238781053932 +2.4774000000000003 0.7069171606667685 0.7069159995165417 -9.59085078976879e-08 -0.09989242048353515 +2.4775 0.7069172178712463 0.7069160578245621 -9.466297545227681e-08 -0.09989245314661627 +2.4776000000000002 0.7069172750717133 0.7069161161015308 -9.340592542223664e-08 -0.09989248579978555 +2.4777000000000005 0.7069173322682952 0.7069161743473331 -9.213765122476764e-08 -0.09989251844304611 +2.4778000000000002 0.706917389461114 0.7069162325618573 -9.08584487698677e-08 -0.09989255107640091 +2.4779 0.7069174466502892 0.7069162907449953 -8.956861639874969e-08 -0.09989258369985297 +2.478 0.7069175038359357 0.7069163488966417 -8.826845482312606e-08 -0.09989261631340524 +2.4781000000000004 0.7069175610181664 0.7069164070166948 -8.695826703673804e-08 -0.09989264891706075 +2.4782 0.7069176181970904 0.7069164651050559 -8.563835825550759e-08 -0.09989268151082253 +2.4783000000000004 0.706917675372814 0.70691652316163 -8.430903585075061e-08 -0.09989271409469357 +2.4784 0.7069177325454393 0.7069165811863249 -8.297060926591021e-08 -0.09989274666867684 +2.4785 0.7069177897150657 0.7069166391790519 -8.162338995063717e-08 -0.09989277923277534 +2.4786000000000006 0.7069178468817892 0.7069166971397259 -8.026769128879896e-08 -0.09989281178699211 +2.4787000000000003 0.7069179040457021 0.7069167550682651 -7.890382852909078e-08 -0.09989284433133011 +2.4788 0.7069179612068932 0.706916812964591 -7.753211870697302e-08 -0.09989287686579229 +2.4789 0.7069180183654482 0.7069168708286285 -7.615288056574132e-08 -0.09989290939038169 +2.479 0.7069180755214496 0.7069169286603062 -7.476643449190815e-08 -0.09989294190510133 +2.4791000000000003 0.706918132674976 0.7069169864595557 -7.337310243757389e-08 -0.09989297440995419 +2.4792 0.7069181898261025 0.7069170442263126 -7.197320784886954e-08 -0.09989300690494322 +2.4793000000000003 0.7069182469749011 0.7069171019605156 -7.056707558442468e-08 -0.09989303939007146 +2.4794 0.7069183041214397 0.7069171596621071 -6.915503184207542e-08 -0.09989307186534185 +2.4795 0.7069183612657832 0.706917217331033 -6.77374040855723e-08 -0.09989310433075742 +2.4796000000000005 0.7069184184079926 0.7069172749672425 -6.631452096825252e-08 -0.09989313678632111 +2.4797000000000002 0.7069184755481257 0.7069173325706889 -6.488671225454365e-08 -0.09989316923203598 +2.4798 0.7069185326862367 0.7069173901413287 -6.345430874537053e-08 -0.099893201667905 +2.4799 0.7069185898223758 0.7069174476791216 -6.201764220442954e-08 -0.09989323409393111 +2.48 0.7069186469565903 0.7069175051840311 -6.057704527318714e-08 -0.09989326651011729 +2.4801 0.7069187040889233 0.7069175626560251 -5.9132851403225634e-08 -0.0998932989164666 +2.4802000000000004 0.7069187612194145 0.7069176200950738 -5.7685394771024925e-08 -0.09989333131298193 +2.4803 0.7069188183481002 0.7069176775011516 -5.623501020705565e-08 -0.09989336369966628 +2.4804 0.706918875475013 0.7069177348742367 -5.478203311619877e-08 -0.09989339607652267 +2.4805 0.7069189326001817 0.7069177922143107 -5.332679939643037e-08 -0.09989342844355405 +2.4806000000000004 0.7069189897236317 0.7069178495213588 -5.186964536704752e-08 -0.09989346080076343 +2.4807 0.7069190468453848 0.7069179067953696 -5.041090768854572e-08 -0.09989349314815371 +2.4808000000000003 0.7069191039654588 0.7069179640363358 -4.895092328477315e-08 -0.09989352548572794 +2.4809 0.7069191610838683 0.7069180212442536 -4.749002926356712e-08 -0.0998935578134891 +2.481 0.7069192182006244 0.7069180784191222 -4.602856284156463e-08 -0.09989359013144013 +2.4811000000000005 0.706919275315734 0.7069181355609455 -4.456686126592295e-08 -0.099893622439584 +2.4812000000000003 0.7069193324292009 0.7069181926697299 -4.3105261734603705e-08 -0.09989365473792372 +2.4813 0.7069193895410251 0.7069182497454863 -4.16441013208988e-08 -0.09989368702646224 +2.4814000000000003 0.7069194466512028 0.7069183067882288 -4.0183716894324345e-08 -0.09989371930520256 +2.4815 0.7069195037597267 0.7069183637979748 -3.872444504491625e-08 -0.09989375157414754 +2.4816000000000003 0.7069195608665861 0.7069184207747458 -3.7266622001535556e-08 -0.09989378383330023 +2.4817000000000005 0.7069196179717667 0.7069184777185672 -3.58105835588339e-08 -0.09989381608266368 +2.4818000000000002 0.70691967507525 0.7069185346294671 -3.4356664998743715e-08 -0.09989384832224073 +2.4819 0.7069197321770142 0.706918591507478 -3.290520101143987e-08 -0.09989388055203435 +2.482 0.7069197892770347 0.7069186483526356 -3.14565256202045e-08 -0.09989391277204758 +2.4821000000000004 0.7069198463752822 0.7069187051649792 -3.0010972104557027e-08 -0.09989394498228338 +2.4822 0.7069199034717242 0.7069187619445517 -2.8568872921649544e-08 -0.09989397718274463 +2.4823000000000004 0.706919960566325 0.7069188186913995 -2.7130559631782097e-08 -0.09989400937343437 +2.4824 0.7069200176590451 0.7069188754055729 -2.569636282315907e-08 -0.09989404155435558 +2.4825 0.7069200747498413 0.706918932087125 -2.426661203187505e-08 -0.09989407372551116 +2.4826000000000006 0.7069201318386669 0.7069189887361131 -2.284163567317643e-08 -0.09989410588690407 +2.4827000000000004 0.706920188925472 0.7069190453525976 -2.142176095711046e-08 -0.0998941380385373 +2.4828 0.7069202460102029 0.706919101936643 -2.0007313820437356e-08 -0.09989417018041381 +2.4829 0.7069203030928026 0.7069191584883165 -1.8598618848567755e-08 -0.0998942023125366 +2.483 0.7069203601732102 0.7069192150076893 -1.7195999202270634e-08 -0.09989423443490847 +2.4831000000000003 0.7069204172513621 0.7069192714948356 -1.5799776542646526e-08 -0.0998942665475325 +2.4832 0.7069204743271907 0.7069193279498336 -1.4410270960003857e-08 -0.09989429865041166 +2.4833000000000003 0.706920531400625 0.7069193843727646 -1.3027800896230068e-08 -0.09989433074354886 +2.4834 0.706920588471591 0.7069194407637132 -1.1652683075402681e-08 -0.09989436282694705 +2.4835 0.706920645540011 0.7069194971227676 -1.0285232428328822e-08 -0.09989439490060922 +2.4836000000000005 0.7069207026058038 0.7069195534500192 -8.925762027059414e-09 -0.09989442696453832 +2.4837000000000002 0.7069207596688849 0.706919609745563 -7.574582999887725e-09 -0.09989445901873727 +2.4838 0.706920816729167 0.706919666009497 -6.232004475838215e-09 -0.099894491063209 +2.4839 0.7069208737865589 0.7069197222419223 -4.898333504435581e-09 -0.09989452309795645 +2.484 0.7069209308409665 0.7069197784429437 -3.573874988484216e-09 -0.09989455512298263 +2.4841 0.7069209878922924 0.7069198346126695 -2.2589316112098246e-09 -0.0998945871382905 +2.4842000000000004 0.7069210449404356 0.7069198907512105 -9.538037712072955e-10 -0.09989461914388295 +2.4843 0.7069211019852925 0.7069199468586811 3.4121048608087845e-10 -0.09989465113976294 +2.4844 0.7069211590267557 0.706920002935199 1.625815540355624e-09 -0.09989468312593343 +2.4845 0.706921216064715 0.7069200589808845 2.8997182615134176e-09 -0.09989471510239734 +2.4846000000000004 0.7069212730990573 0.7069201149958615 4.162628075565777e-09 -0.09989474706915759 +2.4847 0.7069213301296657 0.7069201709802568 5.414257029691394e-09 -0.09989477902621714 +2.4848000000000003 0.7069213871564215 0.7069202269342005 6.654319865094516e-09 -0.099894810973579 +2.4849 0.7069214441792016 0.7069202828578256 7.882534075985548e-09 -0.09989484291124603 +2.485 0.7069215011978802 0.7069203387512676 9.098619975500544e-09 -0.09989487483922117 +2.4851000000000005 0.7069215582123295 0.7069203946146658 1.0302300751212357e-08 -0.09989490675750744 +2.4852000000000003 0.7069216152224176 0.7069204504481619 1.149330254059111e-08 -0.09989493866610767 +2.4853 0.7069216722280103 0.7069205062519006 1.2671354492586884e-08 -0.09989497056502487 +2.4854000000000003 0.7069217292289702 0.7069205620260296 1.383618882314086e-08 -0.09989500245426192 +2.4855 0.7069217862251573 0.7069206177706993 1.4987540868094396e-08 -0.09989503433382178 +2.4856000000000003 0.7069218432164291 0.7069206734860629 1.6125149167323105e-08 -0.09989506620370742 +2.4857000000000005 0.7069219002026397 0.7069207291722763 1.7248755498563972e-08 -0.09989509806392169 +2.4858000000000002 0.7069219571836405 0.7069207848294984 1.835810495721263e-08 -0.09989512991446757 +2.4859 0.7069220141592807 0.7069208404578906 1.94529459892831e-08 -0.09989516175534802 +2.486 0.7069220711294067 0.706920896057617 2.0533030481613423e-08 -0.09989519358656594 +2.4861000000000004 0.706922128093862 0.7069209516288444 2.1598113787886508e-08 -0.09989522540812425 +2.4862 0.7069221850524877 0.7069210071717422 2.2647954798019065e-08 -0.09989525722002594 +2.4863000000000004 0.7069222420051224 0.7069210626864819 2.3682315990203318e-08 -0.09989528902227388 +2.4864 0.706922298951602 0.706921118173238 2.47009634829487e-08 -0.09989532081487097 +2.4865 0.7069223558917599 0.7069211736321872 2.570366710100136e-08 -0.09989535259782016 +2.4866 0.7069224128254273 0.706921229063509 2.6690200395293462e-08 -0.0998953843711244 +2.4867000000000004 0.7069224697524332 0.7069212844673849 2.76603407314141e-08 -0.09989541613478663 +2.4868 0.7069225266726036 0.7069213398439986 2.8613869319099594e-08 -0.09989544788880969 +2.4869 0.7069225835857629 0.7069213951935367 2.955057126774463e-08 -0.09989547963319656 +2.487 0.7069226404917328 0.7069214505161876 3.0470235628035636e-08 -0.09989551136795016 +2.4871000000000003 0.7069226973903331 0.7069215058121422 3.137265544399248e-08 -0.09989554309307347 +2.4872 0.7069227542813808 0.7069215610815931 3.2257627806744904e-08 -0.0998955748085693 +2.4873000000000003 0.7069228111646917 0.7069216163247353 3.312495388922698e-08 -0.0998956065144406 +2.4874 0.7069228680400784 0.7069216715417661 3.397443898607577e-08 -0.0998956382106903 +2.4875 0.7069229249073526 0.7069217267328847 3.480589257781608e-08 -0.09989566989732131 +2.4876000000000005 0.7069229817663235 0.706921781898292 3.5619128358616026e-08 -0.09989570157433657 +2.4877000000000002 0.706923038616798 0.7069218370381913 3.641396427792043e-08 -0.09989573324173896 +2.4878 0.7069230954585816 0.7069218921527876 3.7190222582084154e-08 -0.09989576489953143 +2.4879000000000002 0.7069231522914777 0.7069219472422875 3.7947729861209645e-08 -0.09989579654771688 +2.488 0.7069232091152882 0.7069220023068998 3.8686317083841404e-08 -0.09989582818629819 +2.4881 0.7069232659298124 0.7069220573468351 3.940581962992573e-08 -0.09989585981527829 +2.4882000000000004 0.706923322734849 0.7069221123623053 4.010607732897464e-08 -0.09989589143466013 +2.4883 0.7069233795301946 0.7069221673535244 4.0786934496495064e-08 -0.09989592304444661 +2.4884 0.7069234363156437 0.7069222223207074 4.1448239982561086e-08 -0.09989595464464059 +2.4885 0.7069234930909899 0.7069222772640715 4.2089847177018136e-08 -0.09989598623524501 +2.4886000000000004 0.7069235498560249 0.706922332183835 4.271161405978996e-08 -0.09989601781626274 +2.4887 0.7069236066105393 0.7069223870802182 4.331340324077726e-08 -0.09989604938769679 +2.4888000000000003 0.7069236633543219 0.7069224419534419 4.389508197200076e-08 -0.09989608094954994 +2.4889 0.7069237200871596 0.7069224968037294 4.445652218229568e-08 -0.09989611250182513 +2.489 0.7069237768088397 0.7069225516313045 4.4997600506802016e-08 -0.09989614404452529 +2.4891000000000005 0.7069238335191463 0.7069226064363927 4.551819831645487e-08 -0.09989617557765335 +2.4892000000000003 0.7069238902178641 0.7069226612192201 4.601820174400528e-08 -0.09989620710121218 +2.4893 0.7069239469047746 0.7069227159800144 4.649750170136746e-08 -0.09989623861520464 +2.4894000000000003 0.70692400357966 0.7069227707190049 4.695599391778271e-08 -0.09989627011963367 +2.4895 0.7069240602423004 0.706922825436421 4.739357894155416e-08 -0.09989630161450216 +2.4896000000000003 0.7069241168924754 0.7069228801324939 4.781016217821066e-08 -0.09989633309981305 +2.4897000000000005 0.7069241735299632 0.706922934807455 4.8205653906119306e-08 -0.09989636457556916 +2.4898000000000002 0.7069242301545416 0.7069229894615375 4.85799693025063e-08 -0.09989639604177347 +2.4899 0.7069242867659872 0.7069230440949745 4.893302843998748e-08 -0.09989642749842882 +2.49 0.7069243433640757 0.7069230987080006 4.9264756331671156e-08 -0.0998964589455381 +2.4901000000000004 0.7069243999485825 0.706923153300851 4.957508292074975e-08 -0.09989649038310425 +2.4902 0.706924456519282 0.7069232078737613 4.9863943120398435e-08 -0.09989652181113015 +2.4903000000000004 0.7069245130759481 0.706923262426968 5.013127680336682e-08 -0.09989655322961868 +2.4904 0.7069245696183537 0.7069233169607079 5.037702883146922e-08 -0.0998965846385727 +2.4905 0.7069246261462717 0.7069233714752188 5.060114906425828e-08 -0.09989661603799516 +2.4906 0.7069246826594744 0.7069234259707387 5.0803592348616644e-08 -0.09989664742788891 +2.4907000000000004 0.7069247391577335 0.7069234804475059 5.0984318569063936e-08 -0.09989667880825685 +2.4908 0.7069247956408202 0.706923534905759 5.1143292618266445e-08 -0.09989671017910182 +2.4909 0.7069248521085061 0.7069235893457375 5.1280484414384375e-08 -0.09989674154042678 +2.491 0.7069249085605616 0.7069236437676807 5.1395868913214904e-08 -0.09989677289223459 +2.4911000000000003 0.7069249649967575 0.7069236981718281 5.1489426109926906e-08 -0.09989680423452817 +2.4912 0.7069250214168643 0.7069237525584193 5.156114103385678e-08 -0.09989683556731033 +2.4913000000000003 0.7069250778206525 0.7069238069276946 5.1611003757182083e-08 -0.09989686689058402 +2.4914 0.7069251342078924 0.7069238612798934 5.163900940186039e-08 -0.0998968982043521 +2.4915 0.7069251905783542 0.7069239156152556 5.16451581222821e-08 -0.09989692950861746 +2.4916000000000005 0.7069252469318084 0.706923969934021 5.1629455126087076e-08 -0.09989696080338295 +2.4917000000000002 0.7069253032680254 0.7069240242364293 5.159191065161328e-08 -0.09989699208865144 +2.4918 0.7069253595867762 0.7069240785227202 5.15325399713662e-08 -0.09989702336442591 +2.4919000000000002 0.7069254158878313 0.7069241327931325 5.1451363392018834e-08 -0.09989705463070908 +2.492 0.7069254721709621 0.7069241870479055 5.134840624053394e-08 -0.09989708588750393 +2.4921 0.7069255284359401 0.7069242412872779 5.122369885722511e-08 -0.09989711713481332 +2.4922000000000004 0.7069255846825372 0.7069242955114878 5.107727659575678e-08 -0.0998971483726401 +2.4923 0.706925640910526 0.7069243497207731 5.0909179797123394e-08 -0.09989717960098721 +2.4924 0.7069256971196793 0.706924403915371 5.071945380873133e-08 -0.09989721081985747 +2.4925 0.7069257533097703 0.7069244580955185 5.0508148934091945e-08 -0.09989724202925376 +2.4926000000000004 0.706925809480573 0.7069245122614516 5.0275320441495186e-08 -0.09989727322917896 +2.4927 0.7069258656318622 0.7069245664134058 5.0021028553601243e-08 -0.09989730441963596 +2.4928000000000003 0.7069259217634132 0.7069246205516159 4.9745338421419705e-08 -0.09989733560062754 +2.4929 0.7069259778750021 0.706924674676316 4.944832011216649e-08 -0.0998973667721567 +2.493 0.7069260339664059 0.7069247287877394 4.913004859191661e-08 -0.09989739793422624 +2.4931000000000005 0.7069260900374023 0.706924782886118 4.879060370131805e-08 -0.09989742908683899 +2.4932000000000003 0.7069261460877703 0.7069248369716838 4.843007014865286e-08 -0.0998974602299979 +2.4933 0.7069262021172891 0.7069248910446672 4.8048537475142705e-08 -0.09989749136370582 +2.4934000000000003 0.7069262581257397 0.7069249451052972 4.764610004107106e-08 -0.09989752248796557 +2.4935 0.7069263141129039 0.7069249991538027 4.722285699282347e-08 -0.09989755360278006 +2.4936000000000003 0.7069263700785644 0.7069250531904105 4.677891225247921e-08 -0.09989758470815209 +2.4937000000000005 0.7069264260225055 0.7069251072153468 4.631437447964737e-08 -0.0998976158040846 +2.4938000000000002 0.7069264819445125 0.7069251612288368 4.582935705932378e-08 -0.09989764689058042 +2.4939 0.7069265378443718 0.7069252152311034 4.5323978060257675e-08 -0.0998976779676424 +2.494 0.7069265937218713 0.7069252692223693 4.479836021066552e-08 -0.0998977090352734 +2.4941000000000004 0.7069266495768002 0.7069253232028552 4.4252630870475484e-08 -0.09989774009347625 +2.4942 0.7069267054089494 0.7069253771727806 4.368692199489821e-08 -0.0998977711422539 +2.4943 0.7069267612181109 0.7069254311323632 4.3101370122283766e-08 -0.0998978021816091 +2.4944 0.7069268170040786 0.7069254850818195 4.249611632034522e-08 -0.09989783321154475 +2.4945 0.7069268727666476 0.7069255390213646 4.187130614626e-08 -0.09989786423206373 +2.4946 0.7069269285056148 0.7069255929512117 4.1227089629322644e-08 -0.09989789524316893 +2.4947000000000004 0.7069269842207786 0.7069256468715723 4.0563621239719794e-08 -0.09989792624486313 +2.4948 0.7069270399119394 0.7069257007826559 3.9881059831284316e-08 -0.09989795723714916 +2.4949 0.7069270955788991 0.706925754684671 3.9179568613739724e-08 -0.09989798822002993 +2.495 0.7069271512214617 0.706925808577824 3.845931511800571e-08 -0.0998980191935083 +2.4951000000000003 0.7069272068394327 0.7069258624623189 3.7720471151095336e-08 -0.09989805015758706 +2.4952 0.7069272624326196 0.7069259163383586 3.696321275448167e-08 -0.09989808111226911 +2.4953000000000003 0.7069273180008321 0.7069259702061432 3.618772015899496e-08 -0.09989811205755728 +2.4954 0.7069273735438815 0.7069260240658719 3.5394177748393485e-08 -0.09989814299345443 +2.4955 0.7069274290615815 0.7069260779177409 3.458277402640375e-08 -0.0998981739199634 +2.4956000000000005 0.7069274845537474 0.7069261317619446 3.37537015403927e-08 -0.09989820483708703 +2.4957000000000003 0.7069275400201974 0.7069261855986757 3.290715686402046e-08 -0.0998982357448282 +2.4958 0.7069275954607509 0.7069262394281243 3.2043340538259746e-08 -0.09989826664318971 +2.4959000000000002 0.70692765087523 0.7069262932504782 3.1162457040170843e-08 -0.09989829753217443 +2.496 0.7069277062634594 0.7069263470659232 3.0264714699634876e-08 -0.09989832841178517 +2.4961 0.7069277616252652 0.7069264008746428 2.935032568547602e-08 -0.09989835928202478 +2.4962000000000004 0.7069278169604767 0.7069264546768183 2.8419505941276735e-08 -0.09989839014289614 +2.4963 0.706927872268925 0.7069265084726284 2.747247512813189e-08 -0.0998984209944021 +2.4964 0.7069279275504436 0.7069265622622491 2.650945658821957e-08 -0.09989845183654542 +2.4965 0.706927982804869 0.706926616045855 2.5530677273677416e-08 -0.099898482669329 +2.4966000000000004 0.7069280380320397 0.7069266698236172 2.4536367711908147e-08 -0.09989851349275569 +2.4967 0.7069280932317967 0.7069267235957046 2.3526761946598973e-08 -0.09989854430682832 +2.4968000000000004 0.7069281484039838 0.7069267773622834 2.2502097464863202e-08 -0.09989857511154965 +2.4969 0.7069282035484471 0.7069268311235175 2.146261516081105e-08 -0.09989860590692257 +2.497 0.7069282586650357 0.7069268848795681 2.0408559274834315e-08 -0.09989863669294992 +2.4971000000000005 0.7069283137536011 0.7069269386305936 1.9340177338095232e-08 -0.09989866746963454 +2.4972000000000003 0.7069283688139973 0.7069269923767496 1.8257720104004893e-08 -0.09989869823697922 +2.4973 0.7069284238460818 0.7069270461181894 1.7161441495314178e-08 -0.09989872899498684 +2.4974000000000003 0.7069284788497141 0.7069270998550632 1.6051598556408864e-08 -0.0998987597436602 +2.4975 0.7069285338247566 0.7069271535875183 1.492845137264498e-08 -0.09989879048300215 +2.4976000000000003 0.7069285887710747 0.7069272073156996 1.3792263023511275e-08 -0.09989882121301548 +2.4977000000000005 0.7069286436885367 0.7069272610397488 1.2643299514975004e-08 -0.09989885193370307 +2.4978000000000002 0.706928698577014 0.7069273147598045 1.1481829720501324e-08 -0.09989888264506773 +2.4979 0.7069287534363802 0.7069273684760031 1.0308125316868533e-08 -0.09989891334711229 +2.498 0.7069288082665126 0.7069274221884774 9.122460717381209e-09 -0.09989894403983955 +2.4981000000000004 0.7069288630672911 0.7069274758973572 7.925113016359064e-09 -0.09989897472325235 +2.4982 0.7069289178385988 0.7069275296027697 6.716361911941748e-09 -0.09989900539735352 +2.4983 0.7069289725803216 0.706927583304839 5.496489654914505e-09 -0.0998990360621459 +2.4984 0.7069290272923484 0.7069276370036857 4.2657809697782545e-09 -0.09989906671763225 +2.4985 0.7069290819745717 0.7069276906994278 3.0245229975037202e-09 -0.09989909736381547 +2.4986 0.7069291366268867 0.7069277443921802 1.7730052200709556e-09 -0.09989912800069833 +2.4987000000000004 0.7069291912491918 0.706927798082054 5.115194066929174e-10 -0.09989915862828368 +2.4988 0.7069292458413885 0.7069278517691578 -7.596404668491763e-10 -0.0998991892465743 +2.4989 0.7069293004033816 0.7069279054535972 -2.040178284125338e-09 -0.09989921985557305 +2.499 0.7069293549350792 0.7069279591354738 -3.3297958522415794e-09 -0.09989925045528275 +2.4991000000000003 0.7069294094363925 0.7069280128148862 -4.628192979035106e-09 -0.09989928104570618 +2.4992 0.7069294639072357 0.7069280664919301 -5.9350675311875545e-09 -0.09989931162684615 +2.4993000000000003 0.7069295183475263 0.7069281201666978 -7.250115518359079e-09 -0.09989934219870544 +2.4994 0.7069295727571858 0.7069281738392785 -8.573031152168953e-09 -0.09989937276128699 +2.4995 0.7069296271361384 0.7069282275097575 -9.903506925992844e-09 -0.09989940331459352 +2.4996000000000005 0.7069296814843116 0.7069282811782172 -1.1241233680882312e-08 -0.09989943385862783 +2.4997000000000003 0.7069297358016362 0.7069283348447367 -1.2585900677989509e-08 -0.09989946439339281 +2.4998 0.7069297900880469 0.7069283885093915 -1.393719567272661e-08 -0.09989949491889119 +2.4999000000000002 0.706929844343481 0.7069284421722539 -1.529480498849156e-08 -0.09989952543512579 +2.5 0.7069298985678799 0.7069284958333932 -1.6658413582587572e-08 -0.09989955594209948 +2.5001 0.7069299527611876 0.7069285494928742 -1.802770512905616e-08 -0.099899586439815 +2.5002000000000004 0.7069300069233524 0.7069286031507594 -1.940236208416296e-08 -0.0998996169282752 +2.5003 0.7069300610543252 0.7069286568071074 -2.0782065762291885e-08 -0.09989964740748282 +2.5004 0.7069301151540612 0.706928710461973 -2.2166496411405584e-08 -0.09989967787744074 +2.5005 0.7069301692225183 0.7069287641154085 -2.3555333285036478e-08 -0.09989970833815175 +2.5006000000000004 0.7069302232596583 0.706928817767462 -2.4948254720782992e-08 -0.09989973878961864 +2.5007 0.706930277265446 0.7069288714181781 -2.6344938207096408e-08 -0.09989976923184418 +2.5008000000000004 0.7069303312398503 0.7069289250675983 -2.7745060463511828e-08 -0.09989979966483123 +2.5009 0.706930385182843 0.7069289787157604 -2.9148297516542326e-08 -0.09989983008858257 +2.501 0.7069304390943998 0.706929032362699 -3.055432477058577e-08 -0.09989986050310101 +2.5011000000000005 0.7069304929744998 0.7069290860084448 -3.196281708446949e-08 -0.09989989090838935 +2.5012000000000003 0.7069305468231254 0.7069291396530253 -3.337344884864549e-08 -0.09989992130445037 +2.5013 0.7069306006402624 0.7069291932964642 -3.478589405783196e-08 -0.09989995169128685 +2.5014000000000003 0.7069306544259005 0.706929246938782 -3.619982638604011e-08 -0.0998999820689016 +2.5015 0.7069307081800329 0.7069293005799955 -3.7614919264528264e-08 -0.09990001243729742 +2.5016000000000003 0.7069307619026558 0.706929354220118 -3.9030845955093964e-08 -0.09990004279647713 +2.5017000000000005 0.7069308155937697 0.7069294078591597 -4.044727962634756e-08 -0.09990007314644353 +2.5018000000000002 0.7069308692533778 0.7069294614971264 -4.186389342830535e-08 -0.09990010348719937 +2.5019 0.7069309228814873 0.7069295151340215 -4.328036056970672e-08 -0.09990013381874746 +2.502 0.7069309764781087 0.7069295687698436 -4.469635439160438e-08 -0.09990016414109057 +2.5021000000000004 0.7069310300432559 0.7069296224045891 -4.6111548442377606e-08 -0.0999001944542315 +2.5022 0.7069310835769468 0.70692967603825 -4.752561655368059e-08 -0.09990022475817306 +2.5023 0.7069311370792024 0.706929729670815 -4.8938232917244626e-08 -0.09990025505291802 +2.5024 0.7069311905500473 0.7069297833022699 -5.034907215684201e-08 -0.0999002853384692 +2.5025 0.7069312439895094 0.7069298369325959 -5.1757809404247984e-08 -0.09990031561482937 +2.5026 0.7069312973976202 0.706929890561772 -5.316412037600221e-08 -0.0999003458820013 +2.5027000000000004 0.7069313507744152 0.7069299441897723 -5.456768144458668e-08 -0.09990037613998781 +2.5028 0.7069314041199323 0.7069299978165686 -5.596816971616299e-08 -0.09990040638879165 +2.5029 0.7069314574342136 0.706930051442129 -5.736526310267179e-08 -0.09990043662841563 +2.503 0.7069315107173046 0.7069301050664174 -5.8758640396859574e-08 -0.09990046685886249 +2.5031000000000003 0.7069315639692539 0.7069301586893953 -6.01479813468718e-08 -0.09990049708013507 +2.5032 0.7069316171901141 0.70693021231102 -6.153296672802705e-08 -0.09990052729223606 +2.5033000000000003 0.7069316703799403 0.7069302659312461 -6.291327841415756e-08 -0.09990055749516835 +2.5034 0.7069317235387921 0.7069303195500242 -6.428859945740648e-08 -0.0999005876889347 +2.5035 0.7069317766667317 0.7069303731673015 -6.56586141580505e-08 -0.09990061787353782 +2.5036000000000005 0.706931829763825 0.7069304267830221 -6.702300812955198e-08 -0.09990064804898055 +2.5037000000000003 0.7069318828301409 0.7069304803971266 -6.838146838399409e-08 -0.09990067821526565 +2.5038 0.7069319358657522 0.7069305340095526 -6.973368338932667e-08 -0.09990070837239588 +2.5039000000000002 0.7069319888707344 0.7069305876202341 -7.107934315480138e-08 -0.09990073852037404 +2.504 0.7069320418451672 0.7069306412291014 -7.241813929298804e-08 -0.09990076865920289 +2.5041 0.7069320947891327 0.706930694836082 -7.374976509480144e-08 -0.09990079878888522 +2.5042000000000004 0.7069321477027168 0.7069307484411 -7.507391559238505e-08 -0.09990082890942381 +2.5043 0.7069322005860081 0.7069308020440767 -7.639028763977568e-08 -0.09990085902082142 +2.5044 0.7069322534390992 0.7069308556449292 -7.769857997882296e-08 -0.09990088912308082 +2.5045 0.7069323062620851 0.7069309092435718 -7.899849329643521e-08 -0.09990091921620471 +2.5046000000000004 0.7069323590550647 0.706930962839916 -8.0289730312183e-08 -0.09990094930019595 +2.5047 0.7069324118181397 0.7069310164338698 -8.157199583424396e-08 -0.09990097937505733 +2.5048000000000004 0.7069324645514151 0.7069310700253382 -8.284499682618962e-08 -0.09990100944079158 +2.5049 0.7069325172549985 0.7069311236142226 -8.41084424807112e-08 -0.0999010394974014 +2.505 0.7069325699290014 0.7069311772004221 -8.536204428206962e-08 -0.09990106954488964 +2.5051000000000005 0.7069326225735377 0.7069312307838322 -8.660551607461708e-08 -0.09990109958325905 +2.5052000000000003 0.7069326751887249 0.7069312843643452 -8.783857411570617e-08 -0.09990112961251235 +2.5053 0.7069327277746831 0.7069313379418511 -8.906093716329333e-08 -0.09990115963265238 +2.5054000000000003 0.7069327803315353 0.7069313915162362 -9.027232652104172e-08 -0.09990118964368183 +2.5055 0.7069328328594082 0.7069314450873841 -9.147246610510806e-08 -0.09990121964560354 +2.5056000000000003 0.7069328853584304 0.7069314986551753 -9.266108251786837e-08 -0.09990124963842018 +2.5057000000000005 0.7069329378287341 0.706931552219488 -9.38379050964902e-08 -0.09990127962213456 +2.5058000000000002 0.7069329902704542 0.7069316057801968 -9.500266598318902e-08 -0.09990130959674945 +2.5059 0.7069330426837286 0.7069316593371737 -9.615510017900453e-08 -0.09990133956226761 +2.506 0.7069330950686975 0.7069317128902879 -9.729494561579177e-08 -0.09990136951869175 +2.5061000000000004 0.7069331474255045 0.706931766439406 -9.842194320045655e-08 -0.09990139946602468 +2.5062 0.7069331997542956 0.7069318199843917 -9.953583688781381e-08 -0.09990142940426917 +2.5063 0.7069332520552194 0.706931873525106 -1.006363737291599e-07 -0.09990145933342792 +2.5064 0.7069333043284274 0.7069319270614071 -1.0172330392951845e-07 -0.0999014892535037 +2.5065 0.7069333565740736 0.7069319805931505 -1.0279638092136612e-07 -0.09990151916449926 +2.5066 0.7069334087923149 0.7069320341201897 -1.0385536139238816e-07 -0.09990154906641738 +2.5067000000000004 0.7069334609833104 0.7069320876423749 -1.0490000536267363e-07 -0.0999015789592608 +2.5068 0.7069335131472219 0.706932141159554 -1.0593007622374667e-07 -0.09990160884303223 +2.5069 0.7069335652842137 0.7069321946715726 -1.0694534081402696e-07 -0.09990163871773448 +2.507 0.7069336173944526 0.7069322481782736 -1.079455694439832e-07 -0.09990166858337027 +2.5071000000000003 0.7069336694781079 0.7069323016794977 -1.0893053597159363e-07 -0.09990169843994237 +2.5072 0.7069337215353508 0.7069323551750828 -1.0990001783790782e-07 -0.09990172828745351 +2.5073000000000003 0.7069337735663552 0.7069324086648648 -1.1085379612515989e-07 -0.0999017581259064 +2.5074 0.7069338255712977 0.7069324621486777 -1.1179165560620818e-07 -0.09990178795530386 +2.5075 0.7069338775503565 0.7069325156263521 -1.1271338477836235e-07 -0.09990181777564862 +2.5076000000000005 0.7069339295037121 0.7069325690977173 -1.1361877593971115e-07 -0.09990184758694337 +2.5077000000000003 0.7069339814315478 0.7069326225626003 -1.1450762520646973e-07 -0.09990187738919093 +2.5078 0.7069340333340484 0.7069326760208253 -1.1537973259104217e-07 -0.09990190718239396 +2.5079000000000002 0.706934085211401 0.7069327294722154 -1.1623490200202147e-07 -0.09990193696655526 +2.508 0.7069341370637948 0.706932782916591 -1.1707294133266044e-07 -0.09990196674167759 +2.5081 0.7069341888914209 0.7069328363537705 -1.1789366247821897e-07 -0.09990199650776362 +2.5082000000000004 0.7069342406944725 0.7069328897835707 -1.1869688139320989e-07 -0.09990202626481616 +2.5083 0.7069342924731447 0.706932943205806 -1.1948241810874616e-07 -0.0999020560128379 +2.5084 0.7069343442276343 0.7069329966202893 -1.2025009680539933e-07 -0.09990208575183163 +2.5085 0.7069343959581402 0.7069330500268316 -1.209997458201384e-07 -0.09990211548180004 +2.5086000000000004 0.7069344476648631 0.7069331034252417 -1.217311977209229e-07 -0.09990214520274587 +2.5087 0.7069344993480051 0.706933156815327 -1.2244428930149875e-07 -0.09990217491467188 +2.5088000000000004 0.7069345510077703 0.7069332101968933 -1.2313886165599142e-07 -0.09990220461758077 +2.5089 0.7069346026443641 0.7069332635697447 -1.2381476019451831e-07 -0.0999022343114753 +2.509 0.7069346542579943 0.7069333169336833 -1.2447183467614864e-07 -0.09990226399635821 +2.5091000000000006 0.7069347058488693 0.7069333702885103 -1.251099392505367e-07 -0.0999022936722322 +2.5092000000000003 0.7069347574171997 0.7069334236340249 -1.2572893248741224e-07 -0.09990232333910004 +2.5093 0.706934808963197 0.7069334769700248 -1.2632867740607068e-07 -0.09990235299696446 +2.5094000000000003 0.7069348604870747 0.7069335302963066 -1.2690904150833293e-07 -0.09990238264582812 +2.5095 0.7069349119890472 0.7069335836126651 -1.2746989679936205e-07 -0.09990241228569378 +2.5096000000000003 0.7069349634693305 0.7069336369188944 -1.2801111983623548e-07 -0.09990244191656422 +2.5097000000000005 0.7069350149281416 0.7069336902147869 -1.2853259173314924e-07 -0.0999024715384421 +2.5098000000000003 0.7069350663656992 0.7069337435001338 -1.2903419819437767e-07 -0.0999025011513302 +2.5099 0.7069351177822226 0.7069337967747251 -1.29515829542029e-07 -0.09990253075523123 +2.51 0.7069351691779326 0.7069338500383502 -1.2997738074206622e-07 -0.09990256035014794 +2.5101000000000004 0.7069352205530508 0.7069339032907965 -1.304187514164501e-07 -0.09990258993608296 +2.5102 0.7069352719077997 0.7069339565318512 -1.3083984588650732e-07 -0.09990261951303907 +2.5103 0.7069353232424036 0.7069340097612999 -1.3124057316946103e-07 -0.09990264908101901 +2.5104 0.706935374557087 0.706934062978928 -1.3162084699230858e-07 -0.0999026786400255 +2.5105 0.7069354258520751 0.7069341161845193 -1.3198058586467998e-07 -0.09990270819006125 +2.5106 0.7069354771275946 0.7069341693778572 -1.3231971301985723e-07 -0.09990273773112897 +2.5107000000000004 0.7069355283838724 0.7069342225587241 -1.3263815648763277e-07 -0.0999027672632314 +2.5108 0.7069355796211365 0.7069342757269022 -1.3293584908216638e-07 -0.09990279678637129 +2.5109 0.7069356308396151 0.7069343288821723 -1.3321272843494492e-07 -0.09990282630055129 +2.511 0.7069356820395374 0.7069343820243151 -1.33468736984374e-07 -0.09990285580577415 +2.5111000000000003 0.7069357332211328 0.7069344351531104 -1.3370382200526831e-07 -0.09990288530204255 +2.5112 0.7069357843846317 0.706934488268338 -1.3391793561752519e-07 -0.09990291478935927 +2.5113000000000003 0.7069358355302646 0.7069345413697767 -1.3411103478265518e-07 -0.09990294426772699 +2.5114 0.7069358866582625 0.7069345944572052 -1.3428308134021127e-07 -0.0999029737371484 +2.5115 0.7069359377688567 0.7069346475304016 -1.3443404198350273e-07 -0.09990300319762623 +2.5116000000000005 0.7069359888622788 0.706934700589144 -1.3456388827173815e-07 -0.09990303264916317 +2.5117000000000003 0.7069360399387608 0.7069347536332101 -1.3467259665778109e-07 -0.09990306209176202 +2.5118 0.7069360909985347 0.7069348066623776 -1.3476014848294582e-07 -0.09990309152542542 +2.5119000000000002 0.7069361420418325 0.7069348596764237 -1.3482652995618072e-07 -0.09990312095015604 +2.512 0.7069361930688867 0.7069349126751256 -1.3487173218008908e-07 -0.09990315036595665 +2.5121 0.7069362440799296 0.7069349656582609 -1.3489575114399022e-07 -0.09990317977282995 +2.5122000000000004 0.7069362950751934 0.7069350186256065 -1.348985877308584e-07 -0.09990320917077863 +2.5123 0.7069363460549105 0.70693507157694 -1.3488024769997553e-07 -0.0999032385598054 +2.5124 0.7069363970193128 0.7069351245120387 -1.3484074169733962e-07 -0.09990326793991294 +2.5125 0.7069364479686322 0.7069351774306802 -1.3478008524872576e-07 -0.099903297311104 +2.5126000000000004 0.7069364989031006 0.7069352303326428 -1.3469829876142092e-07 -0.09990332667338128 +2.5127 0.7069365498229496 0.7069352832177044 -1.3459540749473364e-07 -0.09990335602674749 +2.5128000000000004 0.7069366007284097 0.7069353360856432 -1.3447144157560653e-07 -0.09990338537120524 +2.5129 0.7069366516197121 0.7069353889362383 -1.343264359864732e-07 -0.09990341470675734 +2.513 0.706936702497087 0.7069354417692691 -1.3416043053576798e-07 -0.0999034440334065 +2.5131000000000006 0.7069367533607638 0.7069354945845151 -1.339734698874162e-07 -0.09990347335115529 +2.5132000000000003 0.7069368042109723 0.7069355473817567 -1.337656035070578e-07 -0.09990350266000653 +2.5133 0.7069368550479407 0.706935600160775 -1.3353688567765976e-07 -0.09990353195996288 +2.5134000000000003 0.7069369058718973 0.7069356529213513 -1.3328737546655645e-07 -0.09990356125102703 +2.5135 0.706936956683069 0.7069357056632681 -1.3301713672544957e-07 -0.09990359053320166 +2.5136000000000003 0.7069370074816828 0.7069357583863082 -1.3272623806785677e-07 -0.09990361980648953 +2.5137000000000005 0.7069370582679642 0.7069358110902555 -1.324147528448255e-07 -0.09990364907089326 +2.5138000000000003 0.7069371090421381 0.7069358637748946 -1.3208275914319834e-07 -0.09990367832641561 +2.5139 0.7069371598044284 0.7069359164400107 -1.3173033975438786e-07 -0.09990370757305916 +2.514 0.7069372105550584 0.7069359690853908 -1.313575821466212e-07 -0.09990373681082673 +2.5141000000000004 0.7069372612942503 0.7069360217108218 -1.3096457846147047e-07 -0.09990376603972094 +2.5142 0.7069373120222249 0.7069360743160928 -1.3055142548089316e-07 -0.09990379525974455 +2.5143 0.706937362739202 0.7069361269009932 -1.301182246046806e-07 -0.09990382447090018 +2.5144 0.7069374134454005 0.7069361794653133 -1.2966508183137604e-07 -0.09990385367319049 +2.5145 0.7069374641410378 0.7069362320088454 -1.2919210770970246e-07 -0.09990388286661821 +2.5146 0.7069375148263305 0.7069362845313827 -1.2869941734376666e-07 -0.09990391205118604 +2.5147000000000004 0.7069375655014936 0.7069363370327197 -1.2818713035142593e-07 -0.09990394122689669 +2.5148 0.7069376161667407 0.7069363895126523 -1.2765537083132827e-07 -0.0999039703937528 +2.5149 0.706937666822284 0.7069364419709774 -1.2710426733342217e-07 -0.09990399955175708 +2.515 0.7069377174683347 0.7069364944074937 -1.265339528277315e-07 -0.0999040287009122 +2.5151000000000003 0.7069377681051019 0.7069365468220017 -1.2594456468006943e-07 -0.09990405784122089 +2.5152 0.7069378187327935 0.7069365992143026 -1.2533624461907866e-07 -0.09990408697268574 +2.5153000000000003 0.7069378693516157 0.7069366515841999 -1.2470913869112865e-07 -0.0999041160953095 +2.5154 0.7069379199617731 0.7069367039314982 -1.2406339722215165e-07 -0.09990414520909484 +2.5155 0.7069379705634692 0.706936756256004 -1.2339917480549967e-07 -0.09990417431404441 +2.5156000000000005 0.7069380211569045 0.7069368085575258 -1.227166302446986e-07 -0.09990420341016092 +2.5157000000000003 0.7069380717422791 0.7069368608358733 -1.2201592652395787e-07 -0.09990423249744701 +2.5158 0.7069381223197901 0.7069369130908583 -1.212972307665372e-07 -0.09990426157590537 +2.5159000000000002 0.7069381728896342 0.7069369653222946 -1.2056071419137837e-07 -0.09990429064553874 +2.516 0.7069382234520047 0.7069370175299974 -1.198065520749414e-07 -0.09990431970634973 +2.5161000000000002 0.7069382740070939 0.7069370697137844 -1.1903492370957114e-07 -0.09990434875834103 +2.5162000000000004 0.7069383245550916 0.706937121873475 -1.1824601236880283e-07 -0.09990437780151531 +2.5163 0.7069383750961862 0.7069371740088908 -1.1744000525358567e-07 -0.09990440683587529 +2.5164 0.7069384256305633 0.7069372261198547 -1.1661709345238414e-07 -0.09990443586142356 +2.5165 0.706938476158407 0.7069372782061928 -1.1577747189434051e-07 -0.09990446487816285 +2.5166000000000004 0.7069385266798989 0.7069373302677326 -1.1492133930243731e-07 -0.09990449388609579 +2.5167 0.7069385771952187 0.7069373823043041 -1.1404889815186392e-07 -0.09990452288522508 +2.5168000000000004 0.7069386277045437 0.7069374343157395 -1.1316035460756657e-07 -0.09990455187555344 +2.5169 0.7069386782080491 0.7069374863018729 -1.1225591849996219e-07 -0.09990458085708347 +2.517 0.7069387287059075 0.7069375382625411 -1.1133580325208003e-07 -0.0999046098298178 +2.5171000000000006 0.7069387791982891 0.706937590197583 -1.1040022583966302e-07 -0.09990463879375916 +2.5172000000000003 0.7069388296853625 0.7069376421068403 -1.0944940674433024e-07 -0.09990466774891024 +2.5173 0.7069388801672927 0.7069376939901566 -1.0848356989459629e-07 -0.09990469669527366 +2.5174000000000003 0.7069389306442433 0.7069377458473782 -1.0750294260775811e-07 -0.09990472563285208 +2.5175 0.7069389811163749 0.7069377976783537 -1.0650775555780256e-07 -0.0999047545616482 +2.5176000000000003 0.7069390315838457 0.7069378494829344 -1.0549824269734387e-07 -0.09990478348166464 +2.5177000000000005 0.7069390820468113 0.706937901260974 -1.0447464121078609e-07 -0.09990481239290405 +2.5178000000000003 0.7069391325054248 0.706937953012329 -1.0343719146835295e-07 -0.09990484129536914 +2.5179 0.7069391829598366 0.7069380047368583 -1.0238613694889265e-07 -0.09990487018906254 +2.518 0.7069392334101945 0.7069380564344236 -1.0132172420778546e-07 -0.09990489907398695 +2.5181000000000004 0.7069392838566435 0.7069381081048892 -1.0024420280495272e-07 -0.09990492795014498 +2.5182 0.7069393342993261 0.706938159748122 -9.91538252467436e-08 -0.09990495681753928 +2.5183 0.7069393847383818 0.7069382113639922 -9.805084692521976e-08 -0.09990498567617258 +2.5184 0.7069394351739473 0.7069382629523722 -9.693552606351158e-08 -0.0999050145260475 +2.5185 0.706939485606157 0.7069383145131372 -9.580812365510283e-08 -0.09990504336716668 +2.5186 0.706939536035142 0.7069383660461654 -9.466890340311535e-08 -0.0999050721995328 +2.5187000000000004 0.7069395864610302 0.706938417551338 -9.35181316439812e-08 -0.09990510102314845 +2.5188 0.7069396368839473 0.706938469028539 -9.235607731448298e-08 -0.09990512983801635 +2.5189 0.7069396873040162 0.7069385204776553 -9.118301186154809e-08 -0.09990515864413918 +2.519 0.706939737721356 0.7069385718985766 -8.999920919714605e-08 -0.09990518744151952 +2.5191000000000003 0.706939788136083 0.7069386232911956 -8.880494562282792e-08 -0.09990521623016002 +2.5192 0.7069398385483114 0.7069386746554084 -8.760049976554163e-08 -0.09990524501006337 +2.5193000000000003 0.7069398889581515 0.7069387259911137 -8.638615252298809e-08 -0.09990527378123223 +2.5194 0.7069399393657108 0.7069387772982132 -8.516218698469136e-08 -0.09990530254366918 +2.5195 0.7069399897710935 0.7069388285766118 -8.392888838255896e-08 -0.09990533129737691 +2.5196000000000005 0.7069400401744015 0.7069388798262177 -8.268654400674785e-08 -0.09990536004235806 +2.5197000000000003 0.7069400905757327 0.7069389310469422 -8.143544315102058e-08 -0.09990538877861531 +2.5198 0.7069401409751824 0.7069389822386991 -8.017587703815221e-08 -0.09990541750615128 +2.5199000000000003 0.7069401913728424 0.7069390334014061 -7.890813875748026e-08 -0.09990544622496861 +2.52 0.7069402417688013 0.7069390845349837 -7.763252319551578e-08 -0.09990547493506993 +2.5201000000000002 0.7069402921631451 0.7069391356393556 -7.634932696048286e-08 -0.09990550363645793 +2.5202000000000004 0.7069403425559561 0.706939186714449 -7.505884832594012e-08 -0.09990553232913521 +2.5203 0.7069403929473131 0.7069392377601936 -7.376138715358554e-08 -0.09990556101310441 +2.5204 0.7069404433372926 0.7069392887765231 -7.24572448238675e-08 -0.09990558968836818 +2.5205 0.7069404937259669 0.7069393397633741 -7.114672416486112e-08 -0.09990561835492917 +2.5206000000000004 0.7069405441134056 0.7069393907206869 -6.983012938851715e-08 -0.09990564701279003 +2.5207 0.7069405944996745 0.706939441648404 -6.850776601303316e-08 -0.09990567566195335 +2.5208000000000004 0.7069406448848368 0.7069394925464725 -6.717994079389819e-08 -0.09990570430242182 +2.5209 0.7069406952689516 0.7069395434148421 -6.584696165320286e-08 -0.09990573293419802 +2.521 0.7069407456520753 0.706939594253466 -6.450913761025037e-08 -0.09990576155728462 +2.5211000000000006 0.7069407960342609 0.7069396450623003 -6.316677870913182e-08 -0.09990579017168424 +2.5212000000000003 0.7069408464155575 0.7069396958413052 -6.182019594369939e-08 -0.09990581877739954 +2.5213 0.7069408967960115 0.7069397465904439 -6.046970119251427e-08 -0.09990584737443312 +2.5214000000000003 0.7069409471756659 0.7069397973096826 -5.9115607135146186e-08 -0.09990587596278766 +2.5215 0.7069409975545597 0.7069398479989917 -5.775822719059076e-08 -0.09990590454246578 +2.5216000000000003 0.7069410479327293 0.7069398986583438 -5.6397875439640616e-08 -0.09990593311347006 +2.5217 0.7069410983102071 0.7069399492877161 -5.503486655441224e-08 -0.09990596167580316 +2.5218000000000003 0.7069411486870226 0.7069399998870884 -5.36695157244034e-08 -0.09990599022946772 +2.5219 0.7069411990632016 0.7069400504564443 -5.230213858450211e-08 -0.09990601877446642 +2.522 0.7069412494387665 0.7069401009957703 -5.0933051140176697e-08 -0.09990604731080177 +2.5221000000000005 0.7069412998137363 0.7069401515050566 -4.9562569695267913e-08 -0.09990607583847644 +2.5222 0.706941350188127 0.7069402019842969 -4.8191010780323194e-08 -0.09990610435749309 +2.5223 0.7069414005619507 0.7069402524334885 -4.68186910788709e-08 -0.09990613286785432 +2.5224 0.7069414509352163 0.7069403028526315 -4.54459273528272e-08 -0.09990616136956278 +2.5225 0.7069415013079294 0.7069403532417298 -4.407303637139954e-08 -0.09990618986262106 +2.5226 0.7069415516800919 0.7069404036007905 -4.270033483730665e-08 -0.09990621834703182 +2.5227000000000004 0.7069416020517028 0.7069404539298243 -4.1328139313350984e-08 -0.09990624682279768 +2.5228 0.7069416524227565 0.7069405042288454 -3.995676615064451e-08 -0.0999062752899212 +2.5229 0.7069417027932459 0.7069405544978709 -3.858653141344641e-08 -0.09990630374840508 +2.523 0.706941753163159 0.7069406047369217 -3.721775080896099e-08 -0.0999063321982519 +2.5231000000000003 0.706941803532481 0.7069406549460218 -3.585073961103694e-08 -0.09990636063946425 +2.5232 0.7069418539011936 0.706940705125199 -3.448581259370576e-08 -0.0999063890720448 +2.5233000000000003 0.7069419042692751 0.706940755274484 -3.31232839516013e-08 -0.0999064174959961 +2.5234 0.7069419546367003 0.7069408053939112 -3.176346723143819e-08 -0.09990644591132085 +2.5235 0.7069420050034411 0.7069408554835184 -3.040667526251449e-08 -0.0999064743180216 +2.5236000000000005 0.7069420553694656 0.7069409055433464 -2.905322007886596e-08 -0.09990650271610102 +2.5237000000000003 0.7069421057347389 0.7069409555734394 -2.770341284976871e-08 -0.09990653110556166 +2.5238 0.7069421560992224 0.7069410055738454 -2.635756381121762e-08 -0.0999065594864062 +2.5239000000000003 0.7069422064628744 0.706941055544615 -2.501598218981535e-08 -0.09990658785863718 +2.524 0.7069422568256502 0.7069411054858028 -2.367897613706968e-08 -0.0999066162222573 +2.5241000000000002 0.706942307187501 0.7069411553974665 -2.2346852654366728e-08 -0.09990664457726915 +2.5242000000000004 0.7069423575483752 0.7069412052796665 -2.101991752401569e-08 -0.09990667292367528 +2.5243 0.7069424079082182 0.7069412551324672 -1.9698475237257818e-08 -0.09990670126147833 +2.5244 0.7069424582669717 0.7069413049559361 -1.8382828927479555e-08 -0.09990672959068092 +2.5245 0.7069425086245742 0.7069413547501435 -1.7073280301257293e-08 -0.09990675791128567 +2.5246000000000004 0.7069425589809613 0.7069414045151633 -1.577012956376425e-08 -0.09990678622329513 +2.5247 0.7069426093360651 0.7069414542510727 -1.4473675357187799e-08 -0.09990681452671196 +2.5248000000000004 0.7069426596898145 0.7069415039579519 -1.3184214687437384e-08 -0.09990684282153876 +2.5249 0.7069427100421355 0.7069415536358841 -1.1902042856490325e-08 -0.09990687110777813 +2.525 0.7069427603929508 0.7069416032849561 -1.0627453396472308e-08 -0.09990689938543265 +2.5251000000000006 0.7069428107421796 0.7069416529052577 -9.36073800070214e-09 -0.09990692765450498 +2.5252000000000003 0.7069428610897386 0.7069417024968812 -8.102186456471205e-09 -0.09990695591499765 +2.5253 0.7069429114355412 0.7069417520599227 -6.8520865847618295e-09 -0.09990698416691333 +2.5254000000000003 0.7069429617794976 0.7069418015944813 -5.610724170858339e-09 -0.0999070124102546 +2.5255 0.706943012121515 0.7069418511006584 -4.378382889753951e-09 -0.09990704064502398 +2.5256000000000003 0.7069430624614976 0.7069419005785597 -3.15534425844588e-09 -0.09990706887122418 +2.5257 0.7069431127993464 0.7069419500282927 -1.9418875552706938e-09 -0.09990709708885771 +2.5258000000000003 0.7069431631349601 0.7069419994499685 -7.382897730667803e-10 -0.09990712529792722 +2.5259 0.7069432134682336 0.706942048843701 4.551744623576548e-10 -0.09990715349843532 +2.526 0.7069432637990594 0.7069420982096071 1.6382329399294848e-09 -0.09990718169038453 +2.5261000000000005 0.7069433141273269 0.7069421475478064 2.8106159335669623e-09 -0.09990720987377749 +2.5262000000000002 0.706943364452923 0.7069421968584215 3.97205625769087e-09 -0.09990723804861684 +2.5263 0.7069434147757314 0.7069422461415779 5.1222893366134614e-09 -0.09990726621490516 +2.5264 0.7069434650956328 0.7069422953974038 6.261053260049609e-09 -0.09990729437264503 +2.5265 0.7069435154125054 0.7069423446260302 7.388088835158513e-09 -0.09990732252183901 +2.5266 0.7069435657262249 0.7069423938275907 8.50313965853472e-09 -0.09990735066248971 +2.5267000000000004 0.7069436160366639 0.706942443002222 9.605952170851917e-09 -0.09990737879459977 +2.5268 0.7069436663436924 0.7069424921500629 1.0696275708037273e-08 -0.0999074069181717 +2.5269 0.7069437166471775 0.7069425412712553 1.1773862566323567e-08 -0.09990743503320808 +2.527 0.7069437669469844 0.7069425903659439 1.2838468049086726e-08 -0.09990746313971156 +2.5271000000000003 0.706943817242975 0.7069426394342753 1.3889850530163228e-08 -0.09990749123768473 +2.5272 0.7069438675350088 0.7069426884763992 1.492777151196334e-08 -0.09990751932713014 +2.5273000000000003 0.7069439178229431 0.7069427374924679 1.595199566710448e-08 -0.0999075474080504 +2.5274 0.7069439681066323 0.7069427864826359 1.6962290901728627e-08 -0.09990757548044805 +2.5275 0.7069440183859284 0.7069428354470602 1.795842840494194e-08 -0.09990760354432572 +2.5276000000000005 0.7069440686606814 0.7069428843859002 1.8940182700856456e-08 -0.09990763159968602 +2.5277000000000003 0.7069441189307386 0.7069429332993178 1.9907331701499165e-08 -0.0999076596465315 +2.5278 0.7069441691959448 0.7069429821874769 2.0859656748445365e-08 -0.09990768768486472 +2.5279000000000003 0.7069442194561426 0.7069430310505442 2.1796942675268716e-08 -0.09990771571468826 +2.528 0.7069442697111726 0.7069430798886882 2.271897784830723e-08 -0.0999077437360047 +2.5281000000000002 0.7069443199608729 0.7069431287020802 2.3625554214368183e-08 -0.09990777174881664 +2.5282000000000004 0.7069443702050797 0.706943177490893 2.4516467349300353e-08 -0.09990779975312668 +2.5283 0.7069444204436264 0.7069432262553019 2.5391516498760036e-08 -0.0999078277489373 +2.5284 0.706944470676345 0.7069432749954847 2.6250504638059002e-08 -0.09990785573625123 +2.5285 0.7069445209030654 0.7069433237116207 2.7093238501654793e-08 -0.09990788371507098 +2.5286000000000004 0.7069445711236151 0.7069433724038909 2.791952863172298e-08 -0.0999079116853991 +2.5287 0.7069446213378192 0.7069434210724795 2.872918942325997e-08 -0.09990793964723818 +2.5288000000000004 0.7069446715455019 0.7069434697175718 2.9522039157042768e-08 -0.09990796760059081 +2.5289 0.706944721746485 0.7069435183393549 3.029790004993593e-08 -0.09990799554545957 +2.529 0.7069447719405882 0.7069435669380177 3.105659829132079e-08 -0.09990802348184696 +2.5291000000000006 0.7069448221276295 0.7069436155137515 3.1797964086463515e-08 -0.09990805140975559 +2.5292000000000003 0.7069448723074256 0.7069436640667492 3.252183168080125e-08 -0.09990807932918808 +2.5293 0.7069449224797909 0.7069437125972051 3.322803941198382e-08 -0.09990810724014693 +2.5294 0.7069449726445381 0.7069437611053155 3.391642973936404e-08 -0.09990813514263475 +2.5295 0.7069450228014788 0.7069438095912783 3.4586849278692156e-08 -0.09990816303665409 +2.5296000000000003 0.7069450729504223 0.7069438580552927 3.523914884027979e-08 -0.09990819092220751 +2.5297 0.7069451230911772 0.7069439064975598 3.5873183449816604e-08 -0.09990821879929761 +2.5298000000000003 0.7069451732235499 0.7069439549182821 3.648881239694257e-08 -0.09990824666792696 +2.5299 0.7069452233473454 0.7069440033176635 3.7085899264738265e-08 -0.09990827452809811 +2.53 0.7069452734623675 0.7069440516959091 3.766431194707209e-08 -0.09990830237981357 +2.5301000000000005 0.7069453235684187 0.7069441000532259 3.8223922688498946e-08 -0.09990833022307599 +2.5302000000000002 0.7069453736653 0.706944148389822 3.8764608103342146e-08 -0.09990835805788789 +2.5303 0.706945423752811 0.7069441967059064 3.928624921385737e-08 -0.09990838588425185 +2.5304 0.7069454738307506 0.7069442450016894 3.978873146931461e-08 -0.09990841370217039 +2.5305 0.706945523898916 0.7069442932773831 4.027194477201901e-08 -0.09990844151164607 +2.5306 0.7069455739571033 0.7069443415332005 4.0735783503331735e-08 -0.09990846931268157 +2.5307000000000004 0.7069456240051082 0.7069443897693551 4.118014654275193e-08 -0.09990849710527935 +2.5308 0.7069456740427245 0.7069444379860619 4.160493730955006e-08 -0.09990852488944199 +2.5309 0.7069457240697449 0.7069444861835368 4.201006373327765e-08 -0.09990855266517197 +2.531 0.7069457740859624 0.7069445343619964 4.2395438331829793e-08 -0.09990858043247197 +2.5311000000000003 0.706945824091168 0.7069445825216589 4.2760978204506306e-08 -0.09990860819134452 +2.5312 0.7069458740851522 0.7069446306627425 4.310660504588948e-08 -0.09990863594179211 +2.5313000000000003 0.7069459240677046 0.7069446787854664 4.3432245170130224e-08 -0.0999086636838173 +2.5314 0.7069459740386145 0.7069447268900508 4.373782951268279e-08 -0.0999086914174227 +2.5315 0.7069460239976704 0.7069447749767164 4.402329366846869e-08 -0.09990871914261089 +2.5316000000000005 0.7069460739446594 0.7069448230456847 4.4288577895346126e-08 -0.09990874685938435 +2.5317000000000003 0.7069461238793686 0.7069448710971775 4.453362711064057e-08 -0.09990877456774562 +2.5318 0.7069461738015849 0.7069449191314174 4.475839092236977e-08 -0.0999088022676973 +2.5319000000000003 0.706946223711094 0.7069449671486274 4.49628236327132e-08 -0.09990882995924191 +2.532 0.7069462736076817 0.7069450151490307 4.514688424321622e-08 -0.09990885764238203 +2.5321000000000002 0.7069463234911335 0.7069450631328513 4.5310536479076235e-08 -0.0999088853171202 +2.5322000000000005 0.706946373361234 0.7069451111003129 4.5453748778734315e-08 -0.09990891298345891 +2.5323 0.706946423217768 0.7069451590516402 4.557649429560995e-08 -0.09990894064140082 +2.5324 0.7069464730605198 0.7069452069870575 4.5678750911978816e-08 -0.09990896829094836 +2.5325 0.7069465228892737 0.7069452549067898 4.576050125805475e-08 -0.09990899593210409 +2.5326000000000004 0.7069465727038136 0.7069453028110626 4.582173269290779e-08 -0.09990902356487066 +2.5327 0.7069466225039236 0.7069453507001 4.586243730272943e-08 -0.09990905118925053 +2.5328000000000004 0.706946672289388 0.7069453985741275 4.588261192164933e-08 -0.09990907880524628 +2.5329 0.7069467220599903 0.70694544643337 4.588225811091862e-08 -0.0999091064128604 +2.533 0.7069467718155151 0.7069454942780523 4.58613821745224e-08 -0.0999091340120955 +2.5331000000000006 0.706946821555746 0.7069455421083991 4.581999514703672e-08 -0.09990916160295404 +2.5332000000000003 0.7069468712804678 0.7069455899246353 4.575811279015907e-08 -0.09990918918543865 +2.5333 0.7069469209894652 0.7069456377269849 4.567575558056536e-08 -0.09990921675955178 +2.5334 0.7069469706825231 0.7069456855156724 4.5572948727257145e-08 -0.09990924432529603 +2.5335 0.7069470203594262 0.7069457332909213 4.544972213339771e-08 -0.0999092718826739 +2.5336000000000003 0.7069470700199605 0.7069457810529549 4.5306110413659284e-08 -0.09990929943168793 +2.5337 0.7069471196639121 0.7069458288019964 4.5142152859528606e-08 -0.09990932697234071 +2.5338000000000003 0.7069471692910676 0.7069458765382683 4.49578934618583e-08 -0.09990935450463478 +2.5339 0.7069472189012135 0.7069459242619923 4.4753380862294634e-08 -0.09990938202857258 +2.534 0.7069472684941378 0.7069459719733899 4.4528668379298364e-08 -0.09990940954415671 +2.5341000000000005 0.7069473180696285 0.7069460196726818 4.428381395957248e-08 -0.09990943705138966 +2.5342000000000002 0.7069473676274749 0.706946067360088 4.401888019020528e-08 -0.09990946455027401 +2.5343 0.7069474171674661 0.7069461150358276 4.3733934255302254e-08 -0.09990949204081226 +2.5344 0.7069474666893931 0.7069461627001197 4.342904794639446e-08 -0.09990951952300696 +2.5345 0.7069475161930467 0.7069462103531816 4.310429763468293e-08 -0.09990954699686062 +2.5346 0.7069475656782194 0.7069462579952304 4.2759764238078923e-08 -0.0999095744623758 +2.5347000000000004 0.706947615144704 0.7069463056264815 4.2395533219469206e-08 -0.09990960191955503 +2.5348 0.7069476645922943 0.7069463532471503 4.2011694562429924e-08 -0.09990962936840078 +2.5349 0.7069477140207858 0.7069464008574505 4.160834274000158e-08 -0.09990965680891563 +2.535 0.7069477634299746 0.7069464484575949 4.118557670428069e-08 -0.0999096842411021 +2.5351000000000004 0.7069478128196576 0.7069464960477955 4.074349985172532e-08 -0.09990971166496271 +2.5352 0.7069478621896333 0.7069465436282624 4.028221999886894e-08 -0.09990973908049995 +2.5353000000000003 0.7069479115397014 0.7069465911992051 3.980184936150377e-08 -0.09990976648771638 +2.5354 0.7069479608696627 0.7069466387608319 3.9302504526925186e-08 -0.09990979388661453 +2.5355 0.7069480101793195 0.7069466863133491 3.8784306422706694e-08 -0.09990982127719691 +2.5356000000000005 0.7069480594684754 0.7069467338569624 3.8247380288944366e-08 -0.09990984865946607 +2.5357000000000003 0.7069481087369349 0.706946781391876 3.769185564009292e-08 -0.0999098760334245 +2.5358 0.7069481579845045 0.7069468289182921 3.711786625282265e-08 -0.0999099033990747 +2.5359000000000003 0.7069482072109924 0.7069468764364119 3.652555011571246e-08 -0.09990993075641923 +2.536 0.7069482564162077 0.706946923946435 3.591504940669843e-08 -0.0999099581054606 +2.5361000000000002 0.7069483055999612 0.7069469714485592 3.528651045144049e-08 -0.09990998544620132 +2.5362000000000005 0.7069483547620656 0.706947018942981 3.464008369209737e-08 -0.09991001277864386 +2.5363 0.7069484039023352 0.7069470664298947 3.397592364569324e-08 -0.09991004010279078 +2.5364 0.7069484530205861 0.7069471139094939 3.329418889197466e-08 -0.09991006741864467 +2.5365 0.7069485021166357 0.7069471613819694 3.259504199187857e-08 -0.09991009472620796 +2.5366000000000004 0.7069485511903038 0.7069472088475107 3.187864949100172e-08 -0.09991012202548318 +2.5367 0.7069486002414114 0.7069472563063053 3.11451818606201e-08 -0.09991014931647284 +2.5368000000000004 0.7069486492697818 0.7069473037585388 3.039481344738193e-08 -0.09991017659917942 +2.5369 0.7069486982752405 0.7069473512043949 2.9627722452491012e-08 -0.0999102038736055 +2.537 0.7069487472576141 0.7069473986440554 2.884409087619555e-08 -0.0999102311397535 +2.5371000000000006 0.706948796216732 0.7069474460777004 2.804410448829786e-08 -0.09991025839762603 +2.5372000000000003 0.7069488451524251 0.7069474935055075 2.7227952770908503e-08 -0.09991028564722552 +2.5373 0.7069488940645268 0.7069475409276523 2.639582886640457e-08 -0.09991031288855456 +2.5374 0.7069489429528724 0.7069475883443085 2.5547929553143556e-08 -0.09991034012161559 +2.5375 0.7069489918172994 0.7069476357556472 2.468445518301332e-08 -0.09991036734641116 +2.5376000000000003 0.7069490406576473 0.7069476831618379 2.3805609646737613e-08 -0.09991039456294373 +2.5377 0.7069490894737583 0.7069477305630472 2.2911600318364922e-08 -0.09991042177121587 +2.5378000000000003 0.7069491382654762 0.7069477779594402 2.2002637996287877e-08 -0.09991044897123 +2.5379 0.7069491870326479 0.706947825351179 2.1078936870283504e-08 -0.09991047616298868 +2.538 0.7069492357751219 0.7069478727384236 2.014071447814514e-08 -0.09991050334649437 +2.5381000000000005 0.7069492844927496 0.706947920121332 1.918819161981361e-08 -0.09991053052174968 +2.5382000000000002 0.7069493331853846 0.7069479675000592 1.8221592340030013e-08 -0.09991055768875702 +2.5383 0.7069493818528827 0.706948014874758 1.7241143855477314e-08 -0.09991058484751891 +2.5384 0.7069494304951027 0.7069480622455786 1.624707650967755e-08 -0.09991061199803784 +2.5385 0.7069494791119055 0.706948109612669 1.523962372875637e-08 -0.09991063914031628 +2.5386 0.7069495277031548 0.7069481569761744 1.4219021939043675e-08 -0.09991066627435681 +2.5387000000000004 0.7069495762687168 0.7069482043362374 1.318551053151179e-08 -0.09991069340016187 +2.5388 0.7069496248084602 0.7069482516929981 1.213933181667265e-08 -0.09991072051773399 +2.5389 0.7069496733222563 0.7069482990465941 1.108073094217843e-08 -0.09991074762707564 +2.539 0.7069497218099794 0.7069483463971599 1.0009955843381935e-08 -0.09991077472818932 +2.5391000000000004 0.7069497702715061 0.7069483937448275 8.927257192162252e-09 -0.09991080182107755 +2.5392 0.706949818706716 0.7069484410897267 7.832888337944155e-09 -0.09991082890574282 +2.5393000000000003 0.7069498671154912 0.7069484884319837 6.7271052469827786e-09 -0.09991085598218759 +2.5394 0.7069499154977168 0.7069485357717222 5.610166433842045e-09 -0.09991088305041435 +2.5395 0.7069499638532806 0.7069485831090636 4.482332911087683e-09 -0.09991091011042562 +2.5396000000000005 0.7069500121820733 0.7069486304441257 3.343868122500371e-09 -0.0999109371622239 +2.5397000000000003 0.7069500604839882 0.7069486777770242 2.19503788843195e-09 -0.09991096420581166 +2.5398 0.7069501087589223 0.706948725107871 1.0361103407532934e-09 -0.09991099124119142 +2.5399000000000003 0.7069501570067744 0.7069487724367758 -1.3264414566727112e-10 -0.09991101826836563 +2.54 0.7069502052274469 0.7069488197638453 -1.3109530102098366e-09 -0.09991104528733678 +2.5401000000000002 0.7069502534208449 0.7069488670891829 -2.498541569820323e-09 -0.09991107229810739 +2.5402000000000005 0.7069503015868766 0.7069489144128893 -3.6951330805931604e-09 -0.0999110993006799 +2.5403000000000002 0.706950349725453 0.7069489617350622 -4.900448808894953e-09 -0.09991112629505677 +2.5404 0.7069503978364885 0.706949009055796 -6.114208096416607e-09 -0.09991115328124056 +2.5405 0.7069504459199004 0.7069490563751829 -7.336128419153931e-09 -0.0999111802592338 +2.5406000000000004 0.7069504939756089 0.7069491036933109 -8.565925457663937e-09 -0.0999112072290389 +2.5407 0.7069505420035374 0.7069491510102655 -9.803313159514881e-09 -0.09991123419065834 +2.5408000000000004 0.7069505900036122 0.706949198326129 -1.1048003809542573e-08 -0.09991126114409461 +2.5409 0.7069506379757626 0.7069492456409807 -1.2299708094468814e-08 -0.0999112880893502 +2.541 0.7069506859199218 0.7069492929548967 -1.3558135169688262e-08 -0.09991131502642756 +2.5411000000000006 0.7069507338360252 0.70694934026795 -1.4822992733427853e-08 -0.09991134195532918 +2.5412000000000003 0.7069507817240119 0.7069493875802103 -1.6093987081824274e-08 -0.09991136887605755 +2.5413 0.7069508295838243 0.7069494348917442 -1.737082318915492e-08 -0.09991139578861515 +2.5414 0.7069508774154073 0.7069494822026156 -1.8653204770721632e-08 -0.09991142269300447 +2.5415 0.7069509252187096 0.7069495295128843 -1.9940834351372255e-08 -0.09991144958922803 +2.5416000000000003 0.706950972993683 0.7069495768226075 -2.1233413339226404e-08 -0.0999114764772882 +2.5417 0.7069510207402823 0.7069496241318389 -2.253064208552341e-08 -0.09991150335718751 +2.5418000000000003 0.7069510684584657 0.7069496714406291 -2.3832219962684892e-08 -0.0999115302289284 +2.5419 0.7069511161481946 0.7069497187490257 -2.5137845432402633e-08 -0.09991155709251341 +2.542 0.7069511638094338 0.7069497660570723 -2.644721611069073e-08 -0.09991158394794496 +2.5421000000000005 0.706951211442151 0.7069498133648103 -2.7760028844430254e-08 -0.09991161079522559 +2.5422000000000002 0.7069512590463176 0.7069498606722768 -2.9075979775554026e-08 -0.09991163763435768 +2.5423 0.706951306621908 0.7069499079795065 -3.039476441824181e-08 -0.09991166446534376 +2.5424 0.7069513541688999 0.7069499552865302 -3.171607772267139e-08 -0.09991169128818628 +2.5425 0.706951401687274 0.7069500025933756 -3.303961414592542e-08 -0.09991171810288771 +2.5426 0.706951449177015 0.7069500499000673 -3.436506772745186e-08 -0.09991174490945054 +2.5427000000000004 0.7069514966381103 0.706950097206626 -3.5692132157368744e-08 -0.09991177170787718 +2.5428 0.7069515440705512 0.7069501445130704 -3.702050084769624e-08 -0.09991179849817021 +2.5429 0.706951591474331 0.7069501918194143 -3.834986700044455e-08 -0.09991182528033199 +2.543 0.7069516388494479 0.7069502391256693 -3.967992368112284e-08 -0.09991185205436502 +2.5431000000000004 0.7069516861959022 0.7069502864318433 -4.101036388894129e-08 -0.09991187882027178 +2.5432 0.7069517335136984 0.706950333737941 -4.23408806278806e-08 -0.09991190557805472 +2.5433000000000003 0.7069517808028435 0.7069503810439637 -4.367116697757842e-08 -0.09991193232771628 +2.5434 0.7069518280633481 0.7069504283499094 -4.5000916163443405e-08 -0.09991195906925893 +2.5435 0.7069518752952264 0.706950475655773 -4.632982162798213e-08 -0.09991198580268516 +2.5436000000000005 0.7069519224984955 0.706950522961546 -4.765757710060818e-08 -0.09991201252799742 +2.5437000000000003 0.7069519696731761 0.7069505702672165 -4.898387666860994e-08 -0.09991203924519818 +2.5438 0.7069520168192918 0.7069506175727696 -5.030841484805065e-08 -0.09991206595428992 +2.5439000000000003 0.7069520639368694 0.7069506648781867 -5.16308866534013e-08 -0.09991209265527504 +2.544 0.7069521110259396 0.7069507121834462 -5.2950987670073724e-08 -0.09991211934815598 +2.5441000000000003 0.7069521580865358 0.7069507594885236 -5.426841412055697e-08 -0.09991214603293529 +2.5442000000000005 0.7069522051186949 0.7069508067933904 -5.5582862936841976e-08 -0.09991217270961542 +2.5443000000000002 0.706952252122457 0.7069508540980154 -5.689403182970211e-08 -0.09991219937819874 +2.5444 0.7069522990978656 0.7069509014023635 -5.820161935623895e-08 -0.09991222603868775 +2.5445 0.7069523460449669 0.7069509487063974 -5.9505324994909084e-08 -0.09991225269108493 +2.5446000000000004 0.7069523929638108 0.7069509960100757 -6.080484920688994e-08 -0.09991227933539269 +2.5447 0.7069524398544504 0.7069510433133545 -6.209989350915504e-08 -0.09991230597161355 +2.5448000000000004 0.7069524867169416 0.7069510906161858 -6.339016054473026e-08 -0.09991233259974984 +2.5449 0.7069525335513437 0.7069511379185192 -6.467535414687864e-08 -0.0999123592198041 +2.545 0.7069525803577196 0.7069511852203009 -6.595517940913981e-08 -0.0999123858317788 +2.5451000000000006 0.7069526271361346 0.7069512325214738 -6.722934275081582e-08 -0.09991241243567635 +2.5452000000000004 0.7069526738866578 0.7069512798219783 -6.849755199113058e-08 -0.09991243903149927 +2.5453 0.7069527206093608 0.7069513271217505 -6.975951640604203e-08 -0.0999124656192499 +2.5454 0.7069527673043184 0.7069513744207243 -7.101494680110051e-08 -0.09991249219893072 +2.5455 0.706952813971609 0.7069514217188304 -7.226355557866937e-08 -0.0999125187705442 +2.5456000000000003 0.706952860611314 0.7069514690159963 -7.350505679907388e-08 -0.0999125453340928 +2.5457 0.706952907223517 0.7069515163121461 -7.47391662504239e-08 -0.09991257188957892 +2.5458000000000003 0.7069529538083056 0.7069515636072016 -7.596560151366602e-08 -0.099912598437005 +2.5459 0.7069530003657701 0.706951610901081 -7.718408202156413e-08 -0.09991262497637357 +2.546 0.7069530468960037 0.7069516581936999 -7.839432912808836e-08 -0.09991265150768702 +2.5461000000000005 0.7069530933991024 0.7069517054849709 -7.959606617216619e-08 -0.09991267803094779 +2.5462000000000002 0.7069531398751654 0.7069517527748029 -8.07890185375304e-08 -0.0999127045461583 +2.5463 0.7069531863242946 0.706951800063103 -8.197291371993959e-08 -0.09991273105332098 +2.5464 0.706953232746595 0.7069518473497745 -8.314748138442407e-08 -0.09991275755243828 +2.5465 0.7069532791421749 0.7069518946347186 -8.431245342686855e-08 -0.09991278404351273 +2.5466 0.7069533255111446 0.7069519419178334 -8.546756404513578e-08 -0.09991281052654671 +2.5467000000000004 0.7069533718536176 0.7069519891990135 -8.661254978850619e-08 -0.09991283700154263 +2.5468 0.7069534181697106 0.7069520364781512 -8.77471496183932e-08 -0.09991286346850295 +2.5469 0.7069534644595419 0.7069520837551364 -8.887110497513007e-08 -0.09991288992743012 +2.547 0.7069535107232341 0.7069521310298559 -8.998415983001162e-08 -0.09991291637832654 +2.5471000000000004 0.7069535569609112 0.7069521783021934 -9.108606074861164e-08 -0.09991294282119467 +2.5472 0.7069536031727006 0.7069522255720305 -9.217655694629401e-08 -0.09991296925603689 +2.5473000000000003 0.7069536493587323 0.7069522728392461 -9.325540034198915e-08 -0.09991299568285575 +2.5474 0.7069536955191389 0.7069523201037162 -9.432234561804198e-08 -0.09991302210165363 +2.5475 0.7069537416540553 0.7069523673653142 -9.537715027485572e-08 -0.09991304851243293 +2.5476000000000005 0.7069537877636192 0.706952414623911 -9.641957469420925e-08 -0.09991307491519612 +2.5477000000000003 0.7069538338479708 0.706952461879375 -9.744938217742111e-08 -0.09991310130994557 +2.5478 0.7069538799072528 0.7069525091315723 -9.846633901213625e-08 -0.09991312769668376 +2.5479000000000003 0.7069539259416106 0.7069525563803661 -9.947021451656157e-08 -0.09991315407541314 +2.548 0.7069539719511917 0.7069526036256174 -1.004607811001812e-07 -0.09991318044613612 +2.5481000000000003 0.706954017936146 0.7069526508671848 -1.014378143131961e-07 -0.09991320680885513 +2.5482000000000005 0.7069540638966261 0.7069526981049244 -1.0240109289075955e-07 -0.09991323316357253 +2.5483000000000002 0.7069541098327866 0.7069527453386901 -1.0335039880675356e-07 -0.09991325951029083 +2.5484 0.7069541557447847 0.7069527925683335 -1.0428551733103475e-07 -0.09991328584901248 +2.5485 0.7069542016327796 0.7069528397937037 -1.0520623706499616e-07 -0.09991331217973978 +2.5486000000000004 0.7069542474969328 0.7069528870146479 -1.0611234999794578e-07 -0.09991333850247525 +2.5487 0.706954293337408 0.7069529342310108 -1.07003651551342e-07 -0.09991336481722127 +2.5488000000000004 0.7069543391543711 0.7069529814426354 -1.0787994062216172e-07 -0.09991339112398033 +2.5489 0.7069543849479903 0.7069530286493622 -1.0874101962973781e-07 -0.0999134174227548 +2.549 0.7069544307184354 0.7069530758510292 -1.0958669457647452e-07 -0.09991344371354707 +2.5491 0.7069544764658785 0.7069531230474735 -1.1041677505999048e-07 -0.0999134699963596 +2.5492000000000004 0.7069545221904937 0.7069531702385292 -1.1123107433036461e-07 -0.0999134962711948 +2.5493 0.7069545678924573 0.7069532174240293 -1.1202940934824934e-07 -0.09991352253805515 +2.5494 0.7069546135719472 0.7069532646038037 -1.1281160080395258e-07 -0.09991354879694302 +2.5495 0.7069546592291434 0.7069533117776816 -1.1357747317294886e-07 -0.09991357504786082 +2.5496000000000003 0.7069547048642271 0.7069533589454895 -1.1432685474190019e-07 -0.09991360129081095 +2.5497 0.7069547504773821 0.7069534061070526 -1.1505957765202413e-07 -0.09991362752579587 +2.5498000000000003 0.7069547960687935 0.7069534532621943 -1.1577547793552301e-07 -0.09991365375281792 +2.5499 0.7069548416386484 0.7069535004107361 -1.164743955658909e-07 -0.09991367997187961 +2.55 0.7069548871871352 0.706953547552498 -1.1715617447352611e-07 -0.09991370618298329 +2.5501000000000005 0.7069549327144444 0.7069535946872982 -1.1782066259603818e-07 -0.09991373238613137 +2.5502000000000002 0.7069549782207678 0.7069536418149536 -1.184677118938604e-07 -0.09991375858132633 +2.5503 0.7069550237062987 0.7069536889352792 -1.1909717840749567e-07 -0.09991378476857055 +2.5504000000000002 0.706955069171232 0.7069537360480886 -1.1970892226965957e-07 -0.09991381094786639 +2.5505 0.7069551146157638 0.7069537831531942 -1.2030280774517899e-07 -0.0999138371192163 +2.5506 0.7069551600400918 0.7069538302504066 -1.2087870326048245e-07 -0.09991386328262265 +2.5507000000000004 0.7069552054444155 0.7069538773395355 -1.2143648142268204e-07 -0.09991388943808793 +2.5508 0.7069552508289351 0.7069539244203892 -1.2197601906988043e-07 -0.09991391558561455 +2.5509 0.7069552961938523 0.706953971492774 -1.2249719727984443e-07 -0.09991394172520489 +2.551 0.7069553415393697 0.7069540185564958 -1.2299990140123007e-07 -0.09991396785686127 +2.5511000000000004 0.7069553868656915 0.7069540656113592 -1.2348402107439926e-07 -0.0999139939805862 +2.5512 0.7069554321730231 0.7069541126571673 -1.2394945025744064e-07 -0.09991402009638206 +2.5513000000000003 0.7069554774615705 0.7069541596937226 -1.243960872660682e-07 -0.09991404620425125 +2.5514 0.7069555227315412 0.7069542067208259 -1.2482383477882553e-07 -0.09991407230419617 +2.5515 0.7069555679831434 0.7069542537382779 -1.252325998457593e-07 -0.09991409839621923 +2.5516000000000005 0.7069556132165863 0.7069543007458776 -1.2562229393005275e-07 -0.09991412448032286 +2.5517000000000003 0.7069556584320799 0.7069543477434234 -1.2599283293231178e-07 -0.09991415055650937 +2.5518 0.7069557036298355 0.7069543947307124 -1.2634413717842186e-07 -0.0999141766247812 +2.5519000000000003 0.7069557488100644 0.706954441707542 -1.2667613147332446e-07 -0.09991420268514078 +2.552 0.7069557939729798 0.7069544886737077 -1.2698874508540459e-07 -0.0999142287375905 +2.5521000000000003 0.7069558391187947 0.7069545356290051 -1.272819117881241e-07 -0.09991425478213281 +2.5522000000000005 0.7069558842477226 0.7069545825732286 -1.2755556983920502e-07 -0.09991428081877 +2.5523000000000002 0.7069559293599785 0.7069546295061722 -1.2780966204307964e-07 -0.09991430684750457 +2.5524 0.7069559744557771 0.7069546764276293 -1.2804413571272655e-07 -0.09991433286833887 +2.5525 0.7069560195353339 0.7069547233373927 -1.282589427043651e-07 -0.09991435888127524 +2.5526000000000004 0.7069560645988653 0.7069547702352552 -1.2845403943653744e-07 -0.09991438488631617 +2.5527 0.7069561096465877 0.7069548171210087 -1.2862938688490422e-07 -0.09991441088346403 +2.5528000000000004 0.7069561546787175 0.7069548639944447 -1.2878495058397943e-07 -0.09991443687272117 +2.5529 0.7069561996954721 0.7069549108553546 -1.2892070064447758e-07 -0.09991446285409 +2.553 0.7069562446970687 0.7069549577035297 -1.2903661176545678e-07 -0.09991448882757295 +2.5531 0.7069562896837249 0.7069550045387607 -1.2913266321523675e-07 -0.09991451479317237 +2.5532000000000004 0.7069563346556587 0.7069550513608385 -1.2920883886609336e-07 -0.09991454075089067 +2.5533 0.7069563796130877 0.7069550981695536 -1.2926512716476823e-07 -0.09991456670073023 +2.5534 0.7069564245562296 0.7069551449646965 -1.2930152116022442e-07 -0.09991459264269341 +2.5535 0.7069564694853029 0.7069551917460577 -1.293180184793602e-07 -0.09991461857678269 +2.5536000000000003 0.7069565144005253 0.7069552385134279 -1.2931462135129523e-07 -0.09991464450300042 +2.5537 0.7069565593021143 0.7069552852665975 -1.2929133659002334e-07 -0.0999146704213489 +2.5538000000000003 0.7069566041902879 0.7069553320053574 -1.2924817559441248e-07 -0.09991469633183063 +2.5539 0.7069566490652637 0.7069553787294987 -1.2918515434473532e-07 -0.09991472223444792 +2.554 0.7069566939272587 0.7069554254388122 -1.2910229339573032e-07 -0.09991474812920322 +2.5541000000000005 0.70695673877649 0.7069554721330895 -1.2899961787139758e-07 -0.09991477401609888 +2.5542000000000002 0.7069567836131744 0.7069555188121225 -1.2887715747193773e-07 -0.09991479989513728 +2.5543 0.706956828437528 0.7069555654757029 -1.2873494642864913e-07 -0.09991482576632078 +2.5544000000000002 0.7069568732497669 0.7069556121236236 -1.285730235299487e-07 -0.0999148516296518 +2.5545 0.7069569180501064 0.7069556587556778 -1.2839143210749415e-07 -0.09991487748513278 +2.5546 0.7069569628387613 0.7069557053716589 -1.281902200084284e-07 -0.09991490333276598 +2.5547000000000004 0.7069570076159459 0.7069557519713605 -1.2796943958844065e-07 -0.09991492917255382 +2.5548 0.7069570523818741 0.706955798554578 -1.2772914770309285e-07 -0.09991495500449869 +2.5549 0.7069570971367587 0.7069558451211062 -1.2746940569394183e-07 -0.09991498082860294 +2.555 0.706957141880812 0.7069558916707419 -1.271902793711921e-07 -0.09991500664486902 +2.5551000000000004 0.7069571866142458 0.7069559382032816 -1.2689183899461387e-07 -0.09991503245329926 +2.5552 0.7069572313372707 0.706955984718523 -1.2657415925793059e-07 -0.09991505825389606 +2.5553000000000003 0.7069572760500963 0.7069560312162646 -1.2623731927494108e-07 -0.09991508404666172 +2.5554 0.7069573207529318 0.7069560776963059 -1.2588140254135571e-07 -0.0999151098315987 +2.5555 0.7069573654459853 0.7069561241584474 -1.255064969400005e-07 -0.09991513560870936 +2.5556000000000005 0.7069574101294636 0.7069561706024903 -1.2511269470265318e-07 -0.09991516137799605 +2.5557000000000003 0.7069574548035726 0.7069562170282371 -1.2470009239269608e-07 -0.09991518713946113 +2.5558 0.7069574994685174 0.7069562634354913 -1.2426879088082987e-07 -0.09991521289310701 +2.5559000000000003 0.7069575441245016 0.7069563098240578 -1.2381889532599166e-07 -0.09991523863893603 +2.556 0.706957588771728 0.7069563561937422 -1.2335051512851747e-07 -0.09991526437695061 +2.5561000000000003 0.7069576334103975 0.7069564025443514 -1.228637639370811e-07 -0.09991529010715304 +2.5562000000000005 0.7069576780407104 0.7069564488756939 -1.2235875959665243e-07 -0.09991531582954573 +2.5563000000000002 0.7069577226628654 0.7069564951875794 -1.2183562412768079e-07 -0.09991534154413104 +2.5564 0.70695776727706 0.7069565414798192 -1.212944836844615e-07 -0.09991536725091144 +2.5565 0.70695781188349 0.7069565877522254 -1.207354685516665e-07 -0.09991539294988917 +2.5566000000000004 0.7069578564823501 0.7069566340046115 -1.2015871309577209e-07 -0.09991541864106662 +2.5567 0.7069579010738332 0.7069566802367935 -1.1956435573209911e-07 -0.09991544432444618 +2.5568 0.7069579456581305 0.7069567264485874 -1.1895253888664914e-07 -0.09991547000003015 +2.5569 0.7069579902354322 0.7069567726398129 -1.1832340898049187e-07 -0.09991549566782101 +2.557 0.7069580348059266 0.7069568188102893 -1.1767711637772349e-07 -0.09991552132782104 +2.5571 0.7069580793698 0.7069568649598386 -1.1701381535771105e-07 -0.09991554698003263 +2.5572000000000004 0.7069581239272378 0.7069569110882838 -1.1633366407345913e-07 -0.09991557262445812 +2.5573 0.7069581684784227 0.7069569571954508 -1.1563682452732371e-07 -0.0999155982610999 +2.5574 0.7069582130235363 0.7069570032811661 -1.1492346250509267e-07 -0.09991562388996028 +2.5575 0.706958257562758 0.7069570493452586 -1.1419374756557743e-07 -0.09991564951104168 +2.5576000000000003 0.7069583020962654 0.7069570953875595 -1.1344785299030602e-07 -0.09991567512434646 +2.5577 0.7069583466242346 0.7069571414079006 -1.126859557297466e-07 -0.09991570072987693 +2.5578000000000003 0.7069583911468392 0.706957187406117 -1.1190823637555192e-07 -0.09991572632763551 +2.5579 0.7069584356642511 0.7069572333820451 -1.1111487912239537e-07 -0.09991575191762453 +2.558 0.70695848017664 0.706957279335523 -1.1030607170899043e-07 -0.09991577749984631 +2.5581000000000005 0.7069585246841736 0.7069573252663919 -1.0948200538166142e-07 -0.09991580307430324 +2.5582000000000003 0.7069585691870177 0.7069573711744941 -1.0864287484577129e-07 -0.09991582864099766 +2.5583 0.7069586136853354 0.7069574170596744 -1.0778887822148614e-07 -0.09991585419993192 +2.5584000000000002 0.7069586581792888 0.7069574629217801 -1.0692021701168286e-07 -0.09991587975110838 +2.5585 0.7069587026690363 0.7069575087606601 -1.0603709603256017e-07 -0.09991590529452939 +2.5586 0.7069587471547352 0.7069575545761659 -1.0513972336680111e-07 -0.0999159308301973 +2.5587000000000004 0.7069587916365397 0.7069576003681513 -1.0422831032974589e-07 -0.09991595635811448 +2.5588 0.7069588361146026 0.7069576461364722 -1.0330307140607453e-07 -0.09991598187828327 +2.5589 0.7069588805890739 0.7069576918809872 -1.023642242055714e-07 -0.09991600739070605 +2.559 0.7069589250601007 0.7069577376015569 -1.0141198941888974e-07 -0.09991603289538514 +2.5591000000000004 0.7069589695278284 0.7069577832980445 -1.004465907516322e-07 -0.09991605839232286 +2.5592 0.7069590139923996 0.7069578289703151 -9.946825487317651e-08 -0.09991608388152157 +2.5593000000000004 0.7069590584539548 0.7069578746182374 -9.847721137243998e-08 -0.09991610936298366 +2.5594 0.7069591029126316 0.7069579202416818 -9.74736927067052e-08 -0.09991613483671145 +2.5595 0.7069591473685655 0.706957965840521 -9.645793413309844e-08 -0.09991616030270728 +2.5596000000000005 0.7069591918218885 0.706958011414631 -9.543017366522161e-08 -0.09991618576097348 +2.5597000000000003 0.7069592362727313 0.70695805696389 -9.439065200376323e-08 -0.09991621121151242 +2.5598 0.706959280721221 0.7069581024881787 -9.333961249920197e-08 -0.09991623665432645 +2.5599000000000003 0.7069593251674828 0.7069581479873808 -9.227730107981558e-08 -0.0999162620894179 +2.56 0.7069593696116385 0.706958193461382 -9.120396620918014e-08 -0.09991628751678913 +2.5601000000000003 0.7069594140538077 0.7069582389100715 -9.011985880116868e-08 -0.09991631293644243 +2.5602000000000005 0.7069594584941068 0.7069582843333408 -8.902523219393027e-08 -0.09991633834838017 +2.5603000000000002 0.7069595029326499 0.7069583297310845 -8.792034206488858e-08 -0.0999163637526047 +2.5604 0.7069595473695484 0.7069583751031996 -8.680544638910853e-08 -0.09991638914911839 +2.5605 0.7069595918049103 0.7069584204495858 -8.568080537077472e-08 -0.0999164145379235 +2.5606000000000004 0.7069596362388415 0.7069584657701458 -8.454668137640453e-08 -0.09991643991902244 +2.5607 0.7069596806714444 0.7069585110647854 -8.340333888193913e-08 -0.0999164652924175 +2.5608 0.7069597251028192 0.7069585563334129 -8.225104441723224e-08 -0.09991649065811108 +2.5609 0.7069597695330627 0.7069586015759394 -8.109006648972239e-08 -0.09991651601610542 +2.561 0.7069598139622686 0.7069586467922794 -7.992067552718696e-08 -0.09991654136640288 +2.5611 0.7069598583905286 0.7069586919823501 -7.874314382223108e-08 -0.09991656670900587 +2.5612000000000004 0.7069599028179303 0.7069587371460713 -7.755774545682714e-08 -0.09991659204391663 +2.5613 0.7069599472445591 0.7069587822833665 -7.636475625460992e-08 -0.09991661737113756 +2.5614 0.7069599916704974 0.7069588273941613 -7.516445369153829e-08 -0.09991664269067095 +2.5615 0.7069600360958241 0.7069588724783848 -7.395711685903236e-08 -0.09991666800251914 +2.5616000000000003 0.7069600805206158 0.7069589175359694 -7.274302637810467e-08 -0.0999166933066845 +2.5617 0.7069601249449455 0.70695896256685 -7.152246434861953e-08 -0.09991671860316935 +2.5618000000000003 0.7069601693688831 0.7069590075709647 -7.029571427079676e-08 -0.09991674389197598 +2.5619 0.7069602137924955 0.7069590525482545 -6.906306099663945e-08 -0.0999167691731067 +2.562 0.7069602582158472 0.7069590974986639 -6.782479064449884e-08 -0.09991679444656387 +2.5621000000000005 0.7069603026389986 0.7069591424221402 -6.658119054573156e-08 -0.09991681971234981 +2.5622000000000003 0.7069603470620078 0.7069591873186338 -6.533254917314227e-08 -0.09991684497046688 +2.5623 0.7069603914849294 0.7069592321880985 -6.40791560750642e-08 -0.0999168702209174 +2.5624000000000002 0.7069604359078151 0.7069592770304909 -6.282130180857229e-08 -0.09991689546370369 +2.5625 0.7069604803307128 0.7069593218457706 -6.155927787139526e-08 -0.09991692069882807 +2.5626 0.7069605247536681 0.7069593666339005 -6.029337663252671e-08 -0.09991694592629277 +2.5627000000000004 0.7069605691767232 0.706959411394847 -5.90238912710761e-08 -0.09991697114610025 +2.5628 0.706960613599917 0.7069594561285795 -5.7751115701892494e-08 -0.09991699635825281 +2.5629 0.7069606580232852 0.70695950083507 -5.6475344509211364e-08 -0.09991702156275274 +2.563 0.7069607024468605 0.7069595455142942 -5.5196872879217235e-08 -0.09991704675960233 +2.5631000000000004 0.706960746870672 0.706959590166231 -5.391599653412418e-08 -0.09991707194880393 +2.5632 0.7069607912947466 0.7069596347908625 -5.263301165693221e-08 -0.09991709713035993 +2.5633000000000004 0.7069608357191071 0.7069596793881735 -5.134821483027824e-08 -0.09991712230427256 +2.5634 0.706960880143773 0.7069597239581527 -5.0061902964336664e-08 -0.09991714747054414 +2.5635 0.7069609245687613 0.7069597685007911 -4.877437322862305e-08 -0.09991717262917704 +2.5636000000000005 0.7069609689940854 0.7069598130160839 -4.7485922982713584e-08 -0.09991719778017352 +2.5637000000000003 0.7069610134197557 0.7069598575040287 -4.619684970989194e-08 -0.09991722292353594 +2.5638 0.7069610578457792 0.7069599019646268 -4.490745094537507e-08 -0.09991724805926658 +2.5639000000000003 0.7069611022721599 0.7069599463978824 -4.361802421174897e-08 -0.09991727318736779 +2.564 0.7069611466988983 0.7069599908038029 -4.2328866945656274e-08 -0.09991729830784182 +2.5641000000000003 0.7069611911259921 0.706960035182399 -4.1040276432141067e-08 -0.09991732342069104 +2.5642000000000005 0.7069612355534356 0.7069600795336848 -3.975254973624925e-08 -0.09991734852591777 +2.5643000000000002 0.7069612799812196 0.7069601238576774 -3.846598363270448e-08 -0.0999173736235243 +2.5644 0.7069613244093327 0.7069601681543966 -3.718087453804392e-08 -0.09991739871351295 +2.5645 0.7069613688377588 0.7069602124238661 -3.589751844553218e-08 -0.09991742379588597 +2.5646000000000004 0.7069614132664801 0.7069602566661123 -3.461621085078508e-08 -0.09991744887064576 +2.5647 0.706961457695475 0.7069603008811653 -3.333724669235538e-08 -0.0999174739377946 +2.5648 0.7069615021247185 0.7069603450690577 -3.206092027258599e-08 -0.09991749899733478 +2.5649 0.706961546554183 0.7069603892298257 -3.0787525200689364e-08 -0.09991752404926864 +2.565 0.706961590983837 0.7069604333635086 -2.951735432053966e-08 -0.09991754909359844 +2.5651 0.7069616354136466 0.7069604774701486 -2.8250699642693236e-08 -0.09991757413032652 +2.5652000000000004 0.7069616798435745 0.7069605215497912 -2.6987852276951288e-08 -0.09991759915945517 +2.5653 0.7069617242735804 0.7069605656024849 -2.5729102367741397e-08 -0.09991762418098671 +2.5654 0.7069617687036207 0.7069606096282816 -2.4474739027113834e-08 -0.09991764919492345 +2.5655 0.7069618131336486 0.7069606536272358 -2.322505026708735e-08 -0.09991767420126768 +2.5656000000000003 0.7069618575636145 0.7069606975994055 -2.1980322935898078e-08 -0.09991769920002168 +2.5657 0.7069619019934656 0.7069607415448516 -2.074084264665904e-08 -0.09991772419118777 +2.5658000000000003 0.706961946423146 0.7069607854636379 -1.9506893718379548e-08 -0.09991774917476821 +2.5659 0.7069619908525973 0.7069608293558316 -1.8278759106576253e-08 -0.09991777415076541 +2.566 0.706962035281757 0.7069608732215027 -1.7056720341256798e-08 -0.09991779911918158 +2.5661000000000005 0.7069620797105607 0.7069609170607241 -1.5841057461433994e-08 -0.09991782408001904 +2.5662000000000003 0.7069621241389403 0.7069609608735719 -1.4632048948338972e-08 -0.0999178490332801 +2.5663 0.7069621685668248 0.7069610046601249 -1.342997166557322e-08 -0.09991787397896704 +2.5664000000000002 0.7069622129941407 0.7069610484204655 -1.2235100791888054e-08 -0.09991789891708218 +2.5665 0.7069622574208112 0.7069610921546781 -1.1047709763505054e-08 -0.09991792384762777 +2.5666 0.7069623018467567 0.7069611358628507 -9.868070206461854e-09 -0.09991794877060621 +2.5667000000000004 0.7069623462718945 0.7069611795450739 -8.696451878932587e-09 -0.0999179736860197 +2.5668 0.7069623906961391 0.7069612232014414 -7.533122604007347e-09 -0.09991799859387057 +2.5669 0.7069624351194022 0.7069612668320494 -6.3783482124463164e-09 -0.09991802349416107 +2.567 0.706962479541593 0.7069613104369971 -5.232392479362358e-09 -0.09991804838689354 +2.5671000000000004 0.7069625239626174 0.7069613540163864 -4.0955170704445876e-09 -0.09991807327207024 +2.5672 0.7069625683823786 0.7069613975703226 -2.9679814786409686e-09 -0.09991809814969349 +2.5673000000000004 0.7069626128007772 0.7069614410989127 -1.8500429539020091e-09 -0.09991812301976553 +2.5674 0.706962657217711 0.7069614846022676 -7.419564641494847e-10 -0.09991814788228873 +2.5675 0.7069627016330754 0.7069615280805 3.5602537758194774e-10 -0.09991817273726536 +2.5676000000000005 0.7069627460467625 0.7069615715337255 1.4436523599822837e-09 -0.0999181975846977 +2.5677000000000003 0.706962790458662 0.7069616149620624 2.5206767411203868e-09 -0.09991822242458798 +2.5678 0.7069628348686612 0.706961658365632 3.586853303087778e-09 -0.09991824725693857 +2.5679000000000003 0.7069628792766444 0.7069617017445575 4.641939393632e-09 -0.0999182720817517 +2.568 0.7069629236824936 0.7069617450989654 5.685695005086533e-09 -0.09991829689902967 +2.5681000000000003 0.7069629680860884 0.7069617884289843 6.717882805595821e-09 -0.09991832170877481 +2.5682000000000005 0.7069630124873054 0.7069618317347452 7.738268206769483e-09 -0.09991834651098935 +2.5683000000000002 0.7069630568860192 0.706961875016382 8.746619417458745e-09 -0.09991837130567557 +2.5684 0.7069631012821015 0.7069619182740308 9.742707487124525e-09 -0.09991839609283577 +2.5685 0.706963145675422 0.70696196150783 1.0726306366552751e-08 -0.09991842087247223 +2.5686000000000004 0.7069631900658478 0.7069620047179205 1.1697192954691904e-08 -0.09991844564458723 +2.5687 0.7069632344532437 0.7069620479044463 1.2655147148959989e-08 -0.0999184704091831 +2.5688 0.706963278837472 0.7069620910675521 1.3599951904225138e-08 -0.09991849516626204 +2.5689 0.7069633232183927 0.7069621342073864 1.4531393264030634e-08 -0.09991851991582634 +2.569 0.7069633675958642 0.7069621773240993 1.5449260425647038e-08 -0.09991854465787833 +2.5691 0.7069634119697419 0.7069622204178432 1.6353345779103468e-08 -0.09991856939242033 +2.5692000000000004 0.706963456339879 0.7069622634887729 1.7243444954892495e-08 -0.09991859411945453 +2.5693 0.7069635007061272 0.7069623065370446 1.8119356878613935e-08 -0.09991861883898322 +2.5694 0.7069635450683354 0.7069623495628177 1.8980883797863057e-08 -0.09991864355100868 +2.5695 0.7069635894263506 0.7069623925662528 1.982783135161953e-08 -0.09991866825553318 +2.5696000000000003 0.706963633780018 0.7069624355475131 2.0660008586727285e-08 -0.09991869295255902 +2.5697 0.7069636781291808 0.7069624785067637 2.1477228022079298e-08 -0.09991871764208848 +2.5698000000000003 0.70696372247368 0.7069625214441715 2.227930569025094e-08 -0.09991874232412379 +2.5699 0.7069637668133546 0.7069625643599051 2.306606116178611e-08 -0.09991876699866727 +2.57 0.7069638111480419 0.7069626072541355 2.383731759723895e-08 -0.09991879166572112 +2.5701000000000005 0.7069638554775772 0.7069626501270354 2.4592901793143995e-08 -0.09991881632528771 +2.5702000000000003 0.7069638998017946 0.7069626929787796 2.5332644202832877e-08 -0.09991884097736929 +2.5703 0.7069639441205252 0.7069627358095436 2.605637900061908e-08 -0.09991886562196806 +2.5704000000000002 0.7069639884335994 0.7069627786195056 2.6763944087002112e-08 -0.0999188902590863 +2.5705 0.7069640327408456 0.7069628214088456 2.7455181154587005e-08 -0.09991891488872635 +2.5706 0.7069640770420906 0.7069628641777448 2.8129935698492647e-08 -0.0999189395108905 +2.5707000000000004 0.7069641213371594 0.7069629069263859 2.8788057070128215e-08 -0.0999189641255809 +2.5708 0.7069641656258752 0.7069629496549537 2.9429398510152915e-08 -0.09991898873279989 +2.5709 0.7069642099080602 0.7069629923636336 3.005381715888433e-08 -0.09991901333254966 +2.571 0.7069642541835351 0.7069630350526137 3.06611741135443e-08 -0.09991903792483255 +2.5711000000000004 0.7069642984521189 0.7069630777220829 3.125133444213668e-08 -0.09991906250965087 +2.5712 0.7069643427136294 0.7069631203722313 3.182416722334602e-08 -0.09991908708700677 +2.5713000000000004 0.7069643869678824 0.7069631630032507 3.237954557949729e-08 -0.09991911165690254 +2.5714 0.7069644312146934 0.7069632056153341 3.291734668696422e-08 -0.09991913621934051 +2.5715 0.7069644754538759 0.706963248208676 3.3437451823006836e-08 -0.09991916077432288 +2.5716000000000006 0.7069645196852427 0.7069632907834715 3.393974637097563e-08 -0.09991918532185197 +2.5717000000000003 0.7069645639086048 0.7069633333399178 3.4424119867149106e-08 -0.09991920986193002 +2.5718 0.7069646081237726 0.7069633758782123 3.489046601808099e-08 -0.0999192343945593 +2.5719000000000003 0.7069646523305548 0.706963418398554 3.533868270927387e-08 -0.09991925891974199 +2.572 0.7069646965287599 0.7069634609011426 3.5768672046812555e-08 -0.09991928343748038 +2.5721000000000003 0.7069647407181947 0.7069635033861795 3.6180340369507125e-08 -0.09991930794777676 +2.5722000000000005 0.7069647848986655 0.7069635458538661 3.6573598273179075e-08 -0.09991933245063339 +2.5723000000000003 0.7069648290699773 0.7069635883044056 3.6948360621069654e-08 -0.09991935694605251 +2.5724 0.7069648732319344 0.7069636307380016 3.730454657159543e-08 -0.09991938143403636 +2.5725 0.7069649173843404 0.7069636731548583 3.764207959916499e-08 -0.0999194059145872 +2.5726000000000004 0.706964961526998 0.7069637155551813 3.7960887487240025e-08 -0.09991943038770734 +2.5727 0.7069650056597094 0.7069637579391763 3.8260902378642325e-08 -0.099919454853399 +2.5728 0.7069650497822757 0.7069638003070502 3.854206076688016e-08 -0.0999194793116644 +2.5729 0.7069650938944976 0.7069638426590099 3.880430350482189e-08 -0.09991950376250582 +2.573 0.7069651379961754 0.7069638849952635 3.904757584112517e-08 -0.09991952820592548 +2.5731 0.7069651820871086 0.7069639273160193 3.9271827408093873e-08 -0.09991955264192569 +2.5732000000000004 0.7069652261670964 0.7069639696214862 3.9477012230351716e-08 -0.09991957707050869 +2.5733 0.7069652702359374 0.7069640119118732 3.966308877167979e-08 -0.09991960149167667 +2.5734 0.7069653142934296 0.7069640541873904 3.983001989685264e-08 -0.09991962590543191 +2.5735 0.7069653583393714 0.7069640964482475 3.997777289592441e-08 -0.09991965031177664 +2.5736000000000003 0.7069654023735603 0.7069641386946551 4.0106319508514954e-08 -0.09991967471071322 +2.5737 0.7069654463957935 0.7069641809268237 4.021563589085009e-08 -0.09991969910224377 +2.5738000000000003 0.7069654904058682 0.7069642231449639 4.030570266259914e-08 -0.09991972348637056 +2.5739 0.7069655344035817 0.7069642653492866 4.0376504887792986e-08 -0.09991974786309582 +2.574 0.7069655783887305 0.7069643075400032 4.042803206615042e-08 -0.09991977223242188 +2.5741000000000005 0.7069656223611119 0.7069643497173244 4.046027814869069e-08 -0.09991979659435095 +2.5742000000000003 0.7069656663205227 0.7069643918814617 4.047324154640708e-08 -0.09991982094888525 +2.5743 0.7069657102667595 0.7069644340326254 4.046692511465444e-08 -0.099919845296027 +2.5744000000000002 0.7069657541996195 0.7069644761710273 4.0441336153149154e-08 -0.09991986963577852 +2.5745 0.7069657981188995 0.7069645182968778 4.039648640249971e-08 -0.09991989396814195 +2.5746 0.7069658420243969 0.7069645604103874 4.0332392042471965e-08 -0.09991991829311958 +2.5747000000000004 0.7069658859159096 0.7069646025117667 4.024907369372388e-08 -0.09991994261071364 +2.5748 0.7069659297932349 0.7069646446012261 4.0146556402193e-08 -0.09991996692092642 +2.5749 0.7069659736561712 0.7069646866789749 4.002486963389229e-08 -0.0999199912237601 +2.575 0.7069660175045169 0.7069647287452229 3.988404726970596e-08 -0.09992001551921692 +2.5751000000000004 0.7069660613380707 0.7069647708001792 3.972412758457278e-08 -0.09992003980729916 +2.5752 0.7069661051566323 0.706964812844052 3.9545153266568045e-08 -0.09992006408800902 +2.5753000000000004 0.7069661489600012 0.7069648548770495 3.934717136486188e-08 -0.09992008836134875 +2.5754 0.7069661927479782 0.7069648968993792 3.913023331053589e-08 -0.09992011262732056 +2.5755 0.7069662365203643 0.706964938911248 3.889439489229707e-08 -0.09992013688592673 +2.5756000000000006 0.7069662802769611 0.706964980912862 3.8639716237395816e-08 -0.09992016113716949 +2.5757000000000003 0.7069663240175708 0.7069650229044269 3.836626180295233e-08 -0.09992018538105102 +2.5758 0.7069663677419966 0.7069650648861472 3.8074100353405194e-08 -0.09992020961757359 +2.5759000000000003 0.7069664114500426 0.7069651068582272 3.776330496571556e-08 -0.09992023384673945 +2.576 0.7069664551415135 0.7069651488208699 3.743395296344765e-08 -0.09992025806855082 +2.5761000000000003 0.7069664988162148 0.7069651907742773 3.7086125947993764e-08 -0.09992028228300986 +2.5762000000000005 0.7069665424739533 0.7069652327186512 3.671990974826733e-08 -0.09992030649011892 +2.5763000000000003 0.7069665861145364 0.7069652746541917 3.6335394417233435e-08 -0.09992033068988017 +2.5764 0.7069666297377729 0.7069653165810981 3.593267419547963e-08 -0.09992035488229585 +2.5765 0.7069666733434719 0.7069653584995685 3.551184749560343e-08 -0.09992037906736814 +2.5766000000000004 0.7069667169314446 0.7069654004098005 3.507301687792619e-08 -0.09992040324509933 +2.5767 0.7069667605015026 0.7069654423119895 3.4616289024472224e-08 -0.0999204274154916 +2.5768 0.7069668040534596 0.7069654842063309 3.414177471294799e-08 -0.09992045157854723 +2.5769 0.706966847587129 0.7069655260930179 3.364958879072122e-08 -0.0999204757342684 +2.577 0.706966891102327 0.7069655679722427 3.313985014533061e-08 -0.09992049988265736 +2.5771 0.7069669345988703 0.7069656098441963 3.261268167326081e-08 -0.09992052402371629 +2.5772000000000004 0.7069669780765772 0.7069656517090686 3.206821026432993e-08 -0.09992054815744744 +2.5773 0.7069670215352676 0.7069656935670474 3.1506566761790866e-08 -0.09992057228385308 +2.5774 0.7069670649747624 0.7069657354183196 3.0927885917228504e-08 -0.09992059640293537 +2.5775 0.7069671083948843 0.7069657772630703 3.033230638709028e-08 -0.09992062051469652 +2.5776000000000003 0.7069671517954573 0.706965819101483 2.971997066503196e-08 -0.09992064461913874 +2.5777 0.7069671951763079 0.7069658609337403 2.909102508018291e-08 -0.09992066871626439 +2.5778000000000003 0.706967238537263 0.7069659027600224 2.8445619748573847e-08 -0.09992069280607559 +2.5779 0.7069672818781514 0.7069659445805079 2.7783908534972923e-08 -0.09992071688857451 +2.578 0.706967325198804 0.7069659863953741 2.710604901992597e-08 -0.0999207409637634 +2.5781000000000005 0.7069673684990536 0.706966028204796 2.6412202458123146e-08 -0.0999207650316445 +2.5782000000000003 0.7069674117787341 0.7069660700089478 2.5702533747173906e-08 -0.09992078909222 +2.5783 0.7069674550376819 0.7069661118080011 2.49772113755653e-08 -0.09992081314549217 +2.5784000000000002 0.7069674982757345 0.7069661536021254 2.4236407403580018e-08 -0.09992083719146318 +2.5785 0.7069675414927319 0.7069661953914892 2.348029740605051e-08 -0.09992086123013523 +2.5786000000000002 0.7069675846885157 0.7069662371762584 2.270906043246035e-08 -0.09992088526151054 +2.5787000000000004 0.70696762786293 0.7069662789565971 2.1922878970515036e-08 -0.09992090928559136 +2.5788 0.7069676710158201 0.7069663207326679 2.1121938897569748e-08 -0.09992093330237993 +2.5789 0.7069677141470339 0.7069663625046303 2.0306429442465412e-08 -0.09992095731187838 +2.579 0.706967757256421 0.7069664042726423 1.9476543134354374e-08 -0.09992098131408891 +2.5791000000000004 0.7069678003438338 0.70696644603686 1.8632475760199663e-08 -0.09992100530901381 +2.5792 0.706967843409126 0.7069664877974373 1.777442632053955e-08 -0.09992102929665526 +2.5793000000000004 0.706967886452154 0.7069665295545257 1.690259698265001e-08 -0.0999210532770155 +2.5794 0.7069679294727762 0.7069665713082743 1.601719302416621e-08 -0.09992107725009665 +2.5795 0.7069679724708533 0.7069666130588304 1.5118422803592213e-08 -0.09992110121590099 +2.5796000000000006 0.7069680154462481 0.7069666548063389 1.4206497687442587e-08 -0.0999211251744307 +2.5797000000000003 0.7069680583988263 0.7069666965509425 1.328163201554794e-08 -0.09992114912568806 +2.5798 0.706968101328455 0.7069667382927811 1.234404305421738e-08 -0.09992117306967516 +2.5799000000000003 0.7069681442350043 0.7069667800319925 1.1393950932921115e-08 -0.09992119700639425 +2.58 0.7069681871183466 0.7069668217687124 1.0431578599187641e-08 -0.09992122093584754 +2.5801000000000003 0.7069682299783568 0.7069668635030735 9.457151767429395e-09 -0.09992124485803722 +2.5802000000000005 0.7069682728149123 0.7069669052352066 8.470898866901055e-09 -0.09992126877296552 +2.5803000000000003 0.7069683156278924 0.7069669469652398 7.47305097664741e-09 -0.09992129268063465 +2.5804 0.7069683584171795 0.7069669886932983 6.463841787339442e-09 -0.09992131658104675 +2.5805 0.7069684011826587 0.7069670304195054 5.443507538824277e-09 -0.09992134047420409 +2.5806000000000004 0.7069684439242172 0.7069670721439812 4.4122869654814045e-09 -0.09992136436010884 +2.5807 0.7069684866417449 0.7069671138668439 3.3704212415788803e-09 -0.0999213882387632 +2.5808 0.7069685293351344 0.7069671555882084 2.3181539196906464e-09 -0.09992141211016939 +2.5809 0.7069685720042809 0.7069671973081877 1.2557308777874643e-09 -0.09992143597432959 +2.581 0.7069686146490821 0.7069672390268913 1.8340027153201932e-10 -0.09992145983124598 +2.5811 0.7069686572694391 0.7069672807444263 -8.98587542048912e-10 -0.09992148368092077 +2.5812000000000004 0.7069686998652547 0.706967322460897 -1.9899800540040813e-09 -0.09992150752335612 +2.5813 0.7069687424364353 0.7069673641764058 -3.0905226615710046e-09 -0.09992153135855432 +2.5814 0.7069687849828894 0.7069674058910516 -4.199958724554476e-09 -0.09992155518651753 +2.5815 0.7069688275045287 0.7069674476049299 -5.318029635582866e-09 -0.0999215790072479 +2.5816000000000003 0.7069688700012675 0.7069674893181348 -6.444474866078298e-09 -0.09992160282074763 +2.5817 0.7069689124730227 0.7069675310307566 -7.579032040849754e-09 -0.09992162662701892 +2.5818000000000003 0.7069689549197151 0.7069675727428828 -8.721436988400055e-09 -0.09992165042606399 +2.5819 0.7069689973412671 0.7069676144545988 -9.871423816386338e-09 -0.09992167421788503 +2.582 0.7069690397376045 0.7069676561659862 -1.102872495325341e-08 -0.09992169800248422 +2.5821000000000005 0.7069690821086557 0.7069676978771242 -1.2193071222826868e-08 -0.09992172177986372 +2.5822000000000003 0.7069691244543528 0.7069677395880889 -1.3364191910666262e-08 -0.09992174555002578 +2.5823 0.7069691667746298 0.7069677812989537 -1.4541814819142573e-08 -0.09992176931297252 +2.5824000000000003 0.7069692090694248 0.7069678230097889 -1.572566633205666e-08 -0.09992179306870622 +2.5825 0.7069692513386774 0.7069678647206616 -1.6915471480558747e-08 -0.09992181681722896 +2.5826000000000002 0.7069692935823314 0.7069679064316365 -1.8110954004297436e-08 -0.09992184055854303 +2.5827000000000004 0.7069693358003328 0.7069679481427751 -1.9311836419507594e-08 -0.09992186429265054 +2.5828 0.7069693779926316 0.7069679898541354 -2.0517840078858318e-08 -0.0999218880195537 +2.5829 0.7069694201591795 0.7069680315657731 -2.1728685239107148e-08 -0.09992191173925474 +2.583 0.7069694622999321 0.7069680732777404 -2.2944091125284838e-08 -0.09992193545175576 +2.5831000000000004 0.7069695044148476 0.7069681149900868 -2.4163775995313802e-08 -0.09992195915705902 +2.5832 0.7069695465038874 0.7069681567028583 -2.5387457203325525e-08 -0.09992198285516662 +2.5833000000000004 0.7069695885670162 0.7069681984160986 -2.66148512690495e-08 -0.0999220065460808 +2.5834 0.7069696306042016 0.7069682401298477 -2.7845673943515878e-08 -0.09992203022980378 +2.5835 0.706969672615414 0.7069682818441427 -2.907964026912027e-08 -0.0999220539063377 +2.5836000000000006 0.7069697146006267 0.7069683235590178 -3.031646465161478e-08 -0.0999220775756847 +2.5837000000000003 0.7069697565598169 0.7069683652745038 -3.1555860924075904e-08 -0.09992210123784698 +2.5838 0.7069697984929639 0.7069684069906287 -3.2797542411739863e-08 -0.0999221248928267 +2.5839000000000003 0.7069698404000513 0.7069684487074176 -3.404122200247571e-08 -0.09992214854062616 +2.584 0.7069698822810646 0.7069684904248918 -3.52866122066333e-08 -0.09992217218124742 +2.5841000000000003 0.7069699241359928 0.7069685321430703 -3.653342522935959e-08 -0.09992219581469268 +2.5842 0.7069699659648283 0.7069685738619684 -3.778137303424127e-08 -0.0999222194409641 +2.5843000000000003 0.706970007767566 0.7069686155815984 -3.903016740965798e-08 -0.09992224306006386 +2.5844 0.7069700495442046 0.7069686573019702 -4.027952003697859e-08 -0.0999222666719942 +2.5845 0.7069700912947454 0.7069686990230899 -4.152914255620968e-08 -0.09992229027675725 +2.5846000000000005 0.706970133019193 0.7069687407449605 -4.277874663102051e-08 -0.09992231387435518 +2.5847 0.7069701747175547 0.7069687824675819 -4.4028044019128125e-08 -0.09992233746479014 +2.5848 0.7069702163898416 0.7069688241909513 -4.527674663388679e-08 -0.09992236104806433 +2.5849 0.7069702580360673 0.7069688659150627 -4.6524566614991516e-08 -0.09992238462417993 +2.585 0.7069702996562488 0.7069689076399068 -4.7771216391239834e-08 -0.09992240819313913 +2.5851 0.706970341250406 0.7069689493654712 -4.901640875013078e-08 -0.09992243175494404 +2.5852000000000004 0.7069703828185621 0.7069689910917405 -5.025985690154146e-08 -0.09992245530959691 +2.5853 0.7069704243607431 0.7069690328186966 -5.1501274545137296e-08 -0.09992247885709984 +2.5854 0.7069704658769782 0.7069690745463176 -5.274037593455683e-08 -0.09992250239745507 +2.5855 0.7069705073672998 0.706969116274579 -5.397687594479485e-08 -0.0999225259306647 +2.5856000000000003 0.706970548831743 0.7069691580034531 -5.5210490140615576e-08 -0.09992254945673089 +2.5857 0.7069705902703463 0.7069691997329093 -5.6440934832280645e-08 -0.09992257297565586 +2.5858000000000003 0.7069706316831509 0.7069692414629138 -5.7667927151009574e-08 -0.0999225964874417 +2.5859 0.7069706730702012 0.7069692831934298 -5.8891185109911925e-08 -0.09992261999209062 +2.586 0.7069707144315451 0.7069693249244179 -6.011042766925628e-08 -0.09992264348960486 +2.5861000000000005 0.7069707557672327 0.706969366655835 -6.132537479957081e-08 -0.09992266697998647 +2.5862000000000003 0.7069707970773174 0.7069694083876351 -6.253574754691224e-08 -0.09992269046323767 +2.5863 0.7069708383618556 0.7069694501197699 -6.374126810052005e-08 -0.0999227139393606 +2.5864000000000003 0.7069708796209067 0.7069694918521874 -6.494165984702663e-08 -0.09992273740835741 +2.5865 0.7069709208545331 0.7069695335848329 -6.613664744505032e-08 -0.0999227608702303 +2.5866000000000002 0.7069709620627999 0.7069695753176493 -6.732595688027296e-08 -0.09992278432498142 +2.5867000000000004 0.7069710032457754 0.7069696170505753 -6.850931553266035e-08 -0.09992280777261292 +2.5868 0.7069710444035311 0.7069696587835477 -6.96864522376113e-08 -0.09992283121312695 +2.5869 0.7069710855361404 0.7069697005165001 -7.085709734797399e-08 -0.09992285464652567 +2.587 0.7069711266436806 0.7069697422493635 -7.202098279346023e-08 -0.09992287807281129 +2.5871000000000004 0.7069711677262311 0.7069697839820654 -7.317784214699863e-08 -0.0999229014919859 +2.5872 0.7069712087838749 0.7069698257145312 -7.432741068024579e-08 -0.09992292490405168 +2.5873000000000004 0.706971249816697 0.706969867446683 -7.546942543080679e-08 -0.09992294830901081 +2.5874 0.7069712908247858 0.7069699091784402 -7.660362525644532e-08 -0.09992297170686543 +2.5875 0.7069713318082322 0.7069699509097195 -7.772975089623269e-08 -0.09992299509761765 +2.5876000000000006 0.7069713727671301 0.7069699926404348 -7.88475450295284e-08 -0.09992301848126971 +2.5877000000000003 0.7069714137015757 0.7069700343704974 -7.99567523388639e-08 -0.09992304185782372 +2.5878 0.7069714546116683 0.7069700760998157 -8.105711956068323e-08 -0.09992306522728185 +2.5879000000000003 0.7069714954975097 0.7069701178282951 -8.214839554866044e-08 -0.09992308858964621 +2.588 0.7069715363592046 0.7069701595558389 -8.323033133268015e-08 -0.09992311194491897 +2.5881000000000003 0.7069715771968602 0.7069702012823473 -8.430268016567516e-08 -0.0999231352931023 +2.5882 0.7069716180105862 0.7069702430077185 -8.536519759821948e-08 -0.09992315863419833 +2.5883000000000003 0.7069716588004951 0.7069702847318475 -8.641764151235548e-08 -0.09992318196820926 +2.5884 0.7069716995667016 0.7069703264546269 -8.745977219271756e-08 -0.09992320529513712 +2.5885 0.7069717403093236 0.7069703681759465 -8.849135237250227e-08 -0.09992322861498415 +2.5886000000000005 0.7069717810284812 0.7069704098956942 -8.951214728984691e-08 -0.0999232519277525 +2.5887000000000002 0.7069718217242967 0.7069704516137552 -9.052192474160586e-08 -0.09992327523344434 +2.5888 0.706971862396895 0.7069704933300116 -9.15204551458007e-08 -0.09992329853206174 +2.5889 0.7069719030464037 0.7069705350443438 -9.250751157457993e-08 -0.09992332182360684 +2.589 0.7069719436729527 0.7069705767566299 -9.348286981666898e-08 -0.09992334510808187 +2.5891 0.7069719842766737 0.7069706184667448 -9.444630842854462e-08 -0.09992336838548889 +2.5892000000000004 0.7069720248577019 0.706970660174562 -9.53976087847419e-08 -0.09992339165583014 +2.5893 0.7069720654161742 0.7069707018799518 -9.633655512469169e-08 -0.09992341491910771 +2.5894 0.706972105952229 0.7069707435827829 -9.726293460302765e-08 -0.09992343817532372 +2.5895 0.7069721464660083 0.7069707852829215 -9.817653733555642e-08 -0.09992346142448033 +2.5896000000000003 0.7069721869576553 0.7069708269802315 -9.907715645823822e-08 -0.0999234846665797 +2.5897 0.706972227427316 0.7069708686745745 -9.996458814887088e-08 -0.09992350790162394 +2.5898000000000003 0.7069722678751384 0.7069709103658104 -1.0083863170428503e-07 -0.0999235311296152 +2.5899 0.7069723083012724 0.7069709520537967 -1.0169908956029344e-07 -0.09992355435055562 +2.59 0.7069723487058701 0.7069709937383889 -1.0254576735153897e-07 -0.09992357756444735 +2.5901000000000005 0.7069723890890858 0.7069710354194403 -1.0337847395052585e-07 -0.09992360077129253 +2.5902000000000003 0.7069724294510755 0.7069710770968023 -1.0419702150404886e-07 -0.09992362397109326 +2.5903 0.7069724697919975 0.7069711187703243 -1.0500122548696977e-07 -0.09992364716385176 +2.5904000000000003 0.7069725101120119 0.7069711604398539 -1.0579090474558545e-07 -0.09992367034957007 +2.5905 0.7069725504112804 0.7069712021052362 -1.0656588151670976e-07 -0.09992369352825033 +2.5906000000000002 0.7069725906899673 0.7069712437663156 -1.0732598149706257e-07 -0.09992371669989475 +2.5907000000000004 0.706972630948238 0.7069712854229333 -1.0807103385541278e-07 -0.09992373986450542 +2.5908 0.7069726711862603 0.7069713270749296 -1.0880087129155891e-07 -0.09992376302208449 +2.5909 0.7069727114042033 0.7069713687221428 -1.0951533006148262e-07 -0.09992378617263406 +2.591 0.7069727516022377 0.7069714103644098 -1.1021425002158414e-07 -0.09992380931615633 +2.5911000000000004 0.7069727917805362 0.7069714520015651 -1.1089747465990729e-07 -0.09992383245265331 +2.5912 0.7069728319392733 0.7069714936334421 -1.1156485113170134e-07 -0.09992385558212724 +2.5913000000000004 0.7069728720786247 0.7069715352598727 -1.122162302923807e-07 -0.09992387870458021 +2.5914 0.706972912198768 0.7069715768806866 -1.1285146673915836e-07 -0.0999239018200144 +2.5915 0.7069729522998817 0.706971618495713 -1.1347041883012776e-07 -0.09992392492843188 +2.5916000000000006 0.7069729923821464 0.7069716601047786 -1.1407294873110041e-07 -0.09992394802983479 +2.5917000000000003 0.7069730324457438 0.706971701707709 -1.1465892242427944e-07 -0.09992397112422517 +2.5918 0.7069730724908574 0.7069717433043288 -1.1522820976550552e-07 -0.0999239942116053 +2.5919 0.7069731125176719 0.7069717848944612 -1.1578068448425682e-07 -0.09992401729197731 +2.592 0.7069731525263727 0.7069718264779272 -1.1631622424956856e-07 -0.09992404036534319 +2.5921000000000003 0.7069731925171471 0.7069718680545476 -1.1683471064921624e-07 -0.09992406343170514 +2.5922 0.7069732324901835 0.7069719096241414 -1.173360292521658e-07 -0.09992408649106527 +2.5923000000000003 0.7069732724456714 0.7069719511865268 -1.1782006962245128e-07 -0.09992410954342573 +2.5924 0.7069733123838015 0.7069719927415204 -1.1828672534172635e-07 -0.09992413258878863 +2.5925 0.7069733523047654 0.7069720342889381 -1.1873589403701978e-07 -0.09992415562715605 +2.5926000000000005 0.7069733922087562 0.7069720758285944 -1.1916747739981748e-07 -0.09992417865853019 +2.5927000000000002 0.7069734320959675 0.7069721173603034 -1.1958138120340966e-07 -0.0999242016829131 +2.5928 0.7069734719665943 0.7069721588838773 -1.199775153306465e-07 -0.09992422470030694 +2.5929 0.706973511820832 0.7069722003991286 -1.2035579378608108e-07 -0.09992424771071386 +2.593 0.7069735516588773 0.7069722419058679 -1.2071613472892928e-07 -0.09992427071413597 +2.5931 0.7069735914809275 0.7069722834039049 -1.2105846047133495e-07 -0.09992429371057529 +2.5932000000000004 0.7069736312871808 0.7069723248930496 -1.213826975130644e-07 -0.09992431670003404 +2.5933 0.706973671077836 0.7069723663731101 -1.2168877654150645e-07 -0.09992433968251428 +2.5934 0.7069737108530929 0.7069724078438945 -1.219766324576932e-07 -0.09992436265801816 +2.5935 0.7069737506131517 0.7069724493052103 -1.222462043849737e-07 -0.09992438562654782 +2.5936000000000003 0.7069737903582133 0.7069724907568636 -1.2249743568289173e-07 -0.09992440858810535 +2.5937 0.7069738300884788 0.7069725321986607 -1.2273027396106362e-07 -0.09992443154269282 +2.5938000000000003 0.7069738698041503 0.7069725736304073 -1.2294467108438234e-07 -0.09992445449031238 +2.5939 0.7069739095054302 0.7069726150519087 -1.231405831816912e-07 -0.09992447743096616 +2.594 0.7069739491925212 0.706972656462969 -1.2331797066833516e-07 -0.09992450036465628 +2.5941000000000005 0.7069739888656265 0.706972697863393 -1.234767982409568e-07 -0.09992452329138479 +2.5942000000000003 0.7069740285249494 0.7069727392529845 -1.2361703489657816e-07 -0.09992454621115386 +2.5943 0.7069740681706937 0.7069727806315473 -1.2373865391698824e-07 -0.09992456912396556 +2.5944000000000003 0.7069741078030638 0.706972821998885 -1.2384163288782501e-07 -0.09992459202982204 +2.5945 0.7069741474222635 0.7069728633548005 -1.239259537055143e-07 -0.0999246149287254 +2.5946000000000002 0.7069741870284973 0.7069729046990973 -1.2399160257900443e-07 -0.09992463782067776 +2.5947000000000005 0.7069742266219694 0.7069729460315786 -1.2403857002282748e-07 -0.0999246607056812 +2.5948 0.7069742662028842 0.7069729873520468 -1.2406685087618108e-07 -0.09992468358373784 +2.5949 0.7069743057714463 0.7069730286603055 -1.2407644427343822e-07 -0.09992470645484976 +2.595 0.7069743453278602 0.7069730699561576 -1.2406735366322919e-07 -0.09992472931901915 +2.5951000000000004 0.7069743848723301 0.706973111239406 -1.2403958681017624e-07 -0.09992475217624802 +2.5952 0.7069744244050602 0.7069731525098539 -1.2399315577581171e-07 -0.09992477502653851 +2.5953000000000004 0.7069744639262545 0.7069731937673049 -1.239280769411294e-07 -0.09992479786989271 +2.5954 0.7069745034361168 0.706973235011563 -1.2384437096668588e-07 -0.09992482070631276 +2.5955 0.7069745429348505 0.7069732762424317 -1.2374206280647837e-07 -0.09992484353580075 +2.5956000000000006 0.7069745824226588 0.7069733174597155 -1.236211816958016e-07 -0.09992486635835876 +2.5957000000000003 0.7069746218997447 0.7069733586632189 -1.2348176115818676e-07 -0.09992488917398894 +2.5958 0.7069746613663104 0.7069733998527472 -1.2332383897070698e-07 -0.09992491198269338 +2.5959 0.7069747008225575 0.7069734410281056 -1.2314745717785514e-07 -0.09992493478447409 +2.596 0.7069747402686879 0.7069734821891 -1.2295266205858413e-07 -0.09992495757933324 +2.5961000000000003 0.7069747797049023 0.7069735233355376 -1.2273950412110268e-07 -0.09992498036727297 +2.5962 0.7069748191314011 0.7069735644672254 -1.2250803811154898e-07 -0.09992500314829539 +2.5963000000000003 0.7069748585483837 0.7069736055839707 -1.2225832297582673e-07 -0.0999250259224025 +2.5964 0.7069748979560493 0.7069736466855822 -1.2199042184919684e-07 -0.09992504868959644 +2.5965 0.7069749373545958 0.7069736877718693 -1.2170440204239963e-07 -0.09992507144987932 +2.5966000000000005 0.706974976744221 0.7069737288426419 -1.2140033502257286e-07 -0.09992509420325328 +2.5967000000000002 0.7069750161251214 0.7069737698977105 -1.210782964028434e-07 -0.09992511694972035 +2.5968 0.7069750554974925 0.706973810936887 -1.2073836592324527e-07 -0.0999251396892826 +2.5969 0.7069750948615294 0.7069738519599842 -1.2038062741602518e-07 -0.09992516242194219 +2.597 0.7069751342174257 0.7069738929668151 -1.2000516880390777e-07 -0.09992518514770116 +2.5971 0.7069751735653744 0.7069739339571945 -1.196120820740748e-07 -0.09992520786656162 +2.5972000000000004 0.7069752129055676 0.706973974930938 -1.1920146323479708e-07 -0.09992523057852569 +2.5973 0.706975252238196 0.7069740158878624 -1.1877341233451633e-07 -0.09992525328359546 +2.5974 0.7069752915634493 0.7069740568277849 -1.1832803339245634e-07 -0.099925275981773 +2.5975 0.7069753308815155 0.7069740977505248 -1.178654344020924e-07 -0.09992529867306038 +2.5976000000000004 0.7069753701925825 0.7069741386559021 -1.1738572729472208e-07 -0.09992532135745975 +2.5977 0.7069754094968361 0.7069741795437384 -1.1688902791344435e-07 -0.09992534403497318 +2.5978000000000003 0.7069754487944608 0.706974220413856 -1.1637545598713883e-07 -0.0999253667056027 +2.5979 0.7069754880856401 0.7069742612660792 -1.1584513509750594e-07 -0.09992538936935046 +2.598 0.7069755273705562 0.7069743021002333 -1.152981926617197e-07 -0.09992541202621853 +2.5981000000000005 0.7069755666493895 0.7069743429161449 -1.1473475987691661e-07 -0.09992543467620901 +2.5982000000000003 0.7069756059223194 0.7069743837136425 -1.141549717184609e-07 -0.099925457319324 +2.5983 0.7069756451895233 0.7069744244925558 -1.1355896688963751e-07 -0.09992547995556551 +2.5984000000000003 0.7069756844511773 0.706974465252716 -1.1294688778695772e-07 -0.09992550258493574 +2.5985 0.7069757237074561 0.7069745059939561 -1.1231888048107708e-07 -0.0999255252074367 +2.5986000000000002 0.7069757629585325 0.7069745467161102 -1.1167509466475378e-07 -0.09992554782307046 +2.5987000000000005 0.7069758022045776 0.7069745874190143 -1.1101568363203196e-07 -0.0999255704318391 +2.5988 0.7069758414457614 0.7069746281025067 -1.1034080422099579e-07 -0.09992559303374475 +2.5989 0.7069758806822514 0.7069746687664269 -1.0965061680683064e-07 -0.09992561562878949 +2.599 0.7069759199142136 0.7069747094106158 -1.0894528524284242e-07 -0.09992563821697535 +2.5991000000000004 0.7069759591418125 0.7069747500349168 -1.0822497682055898e-07 -0.09992566079830448 +2.5992 0.7069759983652105 0.7069747906391749 -1.0748986224457663e-07 -0.09992568337277889 +2.5993000000000004 0.706976037584568 0.7069748312232367 -1.0674011557357949e-07 -0.0999257059404007 +2.5994 0.7069760768000438 0.7069748717869508 -1.0597591419084923e-07 -0.09992572850117198 +2.5995 0.7069761160117946 0.7069749123301683 -1.051974387652338e-07 -0.09992575105509481 +2.5996000000000006 0.7069761552199749 0.7069749528527413 -1.0440487320084041e-07 -0.09992577360217125 +2.5997000000000003 0.7069761944247375 0.7069749933545246 -1.0359840459887165e-07 -0.09992579614240336 +2.5998 0.7069762336262331 0.7069750338353751 -1.027782232003796e-07 -0.09992581867579328 +2.5999 0.7069762728246101 0.7069750742951515 -1.0194452236631651e-07 -0.09992584120234302 +2.6 0.7069763120200152 0.7069751147337149 -1.0109749850554378e-07 -0.09992586372205471 +2.6001000000000003 0.7069763512125928 0.706975155150928 -1.0023735105488263e-07 -0.09992588623493044 +2.6002 0.7069763904024847 0.7069751955466561 -9.936428240278627e-08 -0.09992590874097224 +2.6003000000000003 0.7069764295898309 0.7069752359207668 -9.84784978650538e-08 -0.09992593124018218 +2.6004 0.706976468774769 0.7069752762731297 -9.758020562671693e-08 -0.09992595373256234 +2.6005 0.7069765079574345 0.7069753166036167 -9.66696166943351e-08 -0.09992597621811478 +2.6006000000000005 0.7069765471379603 0.706975356912102 -9.574694485176005e-08 -0.09992599869684159 +2.6007000000000002 0.7069765863164775 0.7069753971984623 -9.481240660202256e-08 -0.09992602116874484 +2.6008 0.7069766254931141 0.7069754374625763 -9.386622112049492e-08 -0.09992604363382658 +2.6009 0.7069766646679962 0.7069754777043253 -9.290861019764507e-08 -0.09992606609208887 +2.601 0.706976703841248 0.7069755179235934 -9.193979819827058e-08 -0.09992608854353385 +2.6011 0.7069767430129897 0.7069755581202666 -9.096001199904863e-08 -0.09992611098816355 +2.6012000000000004 0.7069767821833408 0.7069755982942332 -8.996948094776996e-08 -0.09992613342598 +2.6013 0.7069768213524167 0.7069756384453847 -8.896843679048055e-08 -0.09992615585698525 +2.6014 0.7069768605203317 0.7069756785736145 -8.79571136367871e-08 -0.09992617828118146 +2.6015 0.7069768996871969 0.706975718678819 -8.693574788613129e-08 -0.09992620069857065 +2.6016000000000004 0.7069769388531206 0.7069757587608969 -8.590457819396269e-08 -0.09992622310915486 +2.6017 0.7069769780182087 0.7069757988197494 -8.486384540148245e-08 -0.09992624551293618 +2.6018000000000003 0.7069770171825647 0.7069758388552806 -8.381379248099952e-08 -0.09992626790991667 +2.6019 0.7069770563462893 0.706975878867397 -8.275466448388891e-08 -0.09992629030009836 +2.602 0.7069770955094805 0.7069759188560076 -8.168670847640697e-08 -0.09992631268348333 +2.6021000000000005 0.706977134672234 0.7069759588210249 -8.061017348678229e-08 -0.0999263350600737 +2.6022000000000003 0.706977173834642 0.7069759987623632 -7.952531045057193e-08 -0.09992635742987148 +2.6023 0.7069772129967947 0.7069760386799397 -7.843237214821136e-08 -0.09992637979287872 +2.6024000000000003 0.7069772521587794 0.7069760785736746 -7.733161314343179e-08 -0.09992640214909748 +2.6025 0.7069772913206802 0.7069761184434908 -7.622328972948372e-08 -0.09992642449852986 +2.6026000000000002 0.7069773304825793 0.7069761582893138 -7.510765986018172e-08 -0.09992644684117788 +2.6027000000000005 0.7069773696445553 0.7069761981110719 -7.398498310783735e-08 -0.09992646917704362 +2.6028000000000002 0.7069774088066842 0.7069762379086963 -7.285552058172717e-08 -0.09992649150612909 +2.6029 0.7069774479690398 0.7069762776821216 -7.171953488515834e-08 -0.09992651382843648 +2.603 0.7069774871316916 0.7069763174312838 -7.057729004261021e-08 -0.09992653614396768 +2.6031000000000004 0.7069775262947078 0.7069763571561227 -6.942905144075376e-08 -0.09992655845272479 +2.6032 0.7069775654581529 0.7069763968565816 -6.827508577077201e-08 -0.09992658075470992 +2.6033000000000004 0.706977604622089 0.7069764365326054 -6.71156609615732e-08 -0.09992660304992512 +2.6034 0.7069776437865747 0.7069764761841424 -6.59510461242796e-08 -0.09992662533837238 +2.6035 0.7069776829516663 0.7069765158111438 -6.478151148457331e-08 -0.0999266476200538 +2.6036000000000006 0.7069777221174166 0.7069765554135642 -6.360732832067992e-08 -0.09992666989497144 +2.6037000000000003 0.7069777612838761 0.7069765949913605 -6.242876889744897e-08 -0.09992669216312736 +2.6038 0.7069778004510918 0.7069766345444923 -6.124610641171022e-08 -0.09992671442452356 +2.6039 0.7069778396191081 0.7069766740729231 -6.005961492331832e-08 -0.09992673667916212 +2.604 0.7069778787879664 0.7069767135766184 -5.88695692892334e-08 -0.09992675892704508 +2.6041000000000003 0.7069779179577048 0.7069767530555473 -5.767624510519091e-08 -0.0999267811681745 +2.6042 0.7069779571283589 0.7069767925096815 -5.6479918640432725e-08 -0.0999268034025524 +2.6043000000000003 0.7069779962999612 0.7069768319389962 -5.528086677092023e-08 -0.0999268256301809 +2.6044 0.7069780354725412 0.7069768713434691 -5.407936691796851e-08 -0.09992684785106204 +2.6045 0.7069780746461249 0.7069769107230806 -5.2875696985579465e-08 -0.09992687006519779 +2.6046000000000005 0.7069781138207363 0.7069769500778145 -5.1670135290836014e-08 -0.0999268922725902 +2.6047000000000002 0.7069781529963957 0.7069769894076579 -5.046296050557203e-08 -0.09992691447324138 +2.6048 0.7069781921731204 0.7069770287126003 -4.925445158774234e-08 -0.09992693666715331 +2.6049 0.706978231350925 0.7069770679926344 -4.8044887719297935e-08 -0.09992695885432806 +2.605 0.706978270529821 0.7069771072477562 -4.683454824135069e-08 -0.0999269810347677 +2.6051 0.7069783097098169 0.7069771464779644 -4.562371258765756e-08 -0.09992700320847425 +2.6052000000000004 0.706978348890918 0.7069771856832606 -4.4412660224555766e-08 -0.09992702537544972 +2.6053 0.7069783880731271 0.7069772248636498 -4.3201670579147964e-08 -0.09992704753569621 +2.6054 0.7069784272564434 0.7069772640191399 -4.199102298360814e-08 -0.0999270696892158 +2.6055 0.7069784664408635 0.706977303149741 -4.0780996605338645e-08 -0.09992709183601045 +2.6056000000000004 0.7069785056263809 0.7069773422554673 -3.9571870382229795e-08 -0.09992711397608219 +2.6057 0.7069785448129857 0.7069773813363356 -3.8363922963218465e-08 -0.0999271361094331 +2.6058000000000003 0.7069785840006659 0.7069774203923654 -3.7157432637171216e-08 -0.09992715823606522 +2.6059 0.7069786231894057 0.7069774594235797 -3.5952677274967565e-08 -0.0999271803559806 +2.606 0.7069786623791867 0.7069774984300039 -3.474993426279445e-08 -0.09992720246918124 +2.6061000000000005 0.7069787015699875 0.7069775374116667 -3.35494804366062e-08 -0.09992722457566919 +2.6062000000000003 0.7069787407617838 0.7069775763685997 -3.2351592022710277e-08 -0.0999272466754465 +2.6063 0.7069787799545478 0.7069776153008376 -3.115654457217301e-08 -0.09992726876851514 +2.6064000000000003 0.7069788191482493 0.7069776542084178 -2.996461289555066e-08 -0.0999272908548772 +2.6065 0.7069788583428553 0.706977693091381 -2.8776071003041442e-08 -0.09992731293453476 +2.6066000000000003 0.7069788975383295 0.7069777319497704 -2.7591192037048143e-08 -0.09992733500748978 +2.6067000000000005 0.7069789367346324 0.7069777707836324 -2.6410248215365945e-08 -0.0999273570737443 +2.6068000000000002 0.7069789759317227 0.7069778095930164 -2.52335107635282e-08 -0.09992737913330044 +2.6069 0.706979015129555 0.7069778483779741 -2.406124985452479e-08 -0.09992740118616013 +2.607 0.7069790543280811 0.7069778871385607 -2.289373454830365e-08 -0.09992742323232537 +2.6071000000000004 0.706979093527251 0.7069779258748343 -2.1731232728236516e-08 -0.09992744527179835 +2.6072 0.7069791327270107 0.7069779645868557 -2.0574011039102558e-08 -0.09992746730458099 +2.6073000000000004 0.7069791719273038 0.7069780032746882 -1.9422334825939386e-08 -0.0999274893306753 +2.6074 0.706979211128071 0.7069780419383983 -1.827646807723085e-08 -0.09992751135008335 +2.6075 0.7069792503292507 0.7069780805780554 -1.7136673358987553e-08 -0.09992753336280719 +2.6076000000000006 0.7069792895307775 0.7069781191937314 -1.600321175793465e-08 -0.0999275553688488 +2.6077000000000004 0.7069793287325838 0.7069781577855012 -1.4876342819929167e-08 -0.09992757736821022 +2.6078 0.7069793679345995 0.7069781963534423 -1.3756324491413091e-08 -0.09992759936089346 +2.6079 0.7069794071367509 0.7069782348976353 -1.2643413062601166e-08 -0.0999276213469006 +2.608 0.7069794463389625 0.7069782734181631 -1.1537863101995088e-08 -0.0999276433262336 +2.6081000000000003 0.7069794855411553 0.7069783119151114 -1.0439927406943883e-08 -0.09992766529889452 +2.6082 0.7069795247432483 0.706978350388569 -9.349856943362267e-09 -0.0999276872648854 +2.6083000000000003 0.7069795639451577 0.706978388838627 -8.267900781545878e-09 -0.0999277092242083 +2.6084 0.7069796031467963 0.706978427265379 -7.1943060441295725e-09 -0.09992773117686514 +2.6085 0.7069796423480752 0.7069784656689216 -6.129317856214123e-09 -0.09992775312285802 +2.6086000000000005 0.7069796815489022 0.7069785040493537 -5.073179277712003e-09 -0.09992777506218889 +2.6087000000000002 0.706979720749183 0.7069785424067769 -4.026131256509857e-09 -0.0999277969948598 +2.6088 0.7069797599488207 0.7069785807412957 -2.988412570355259e-09 -0.09992781892087282 +2.6089 0.7069797991477156 0.7069786190530167 -1.9602597722129245e-09 -0.09992784084022997 +2.609 0.7069798383457657 0.7069786573420489 -9.419071338861995e-10 -0.09992786275293322 +2.6091 0.7069798775428662 0.7069786956085038 6.641340168783705e-11 -0.0999278846589845 +2.6092000000000004 0.7069799167389099 0.7069787338524961 1.064472275949524e-09 -0.09992790655838599 +2.6093 0.7069799559337879 0.7069787720741423 2.0520423693604073e-09 -0.09992792845113962 +2.6094 0.7069799951273881 0.7069788102735614 3.0288990465060506e-09 -0.09992795033724747 +2.6095 0.706980034319596 0.7069788484508747 3.9948202176787184e-09 -0.09992797221671149 +2.6096000000000004 0.7069800735102953 0.7069788866062061 4.9495863753065694e-09 -0.09992799408953376 +2.6097 0.7069801126993666 0.7069789247396816 5.8929806590057865e-09 -0.09992801595571621 +2.6098000000000003 0.7069801518866888 0.7069789628514295 6.824788891142408e-09 -0.09992803781526087 +2.6099 0.7069801910721389 0.7069790009415806 7.74479963754765e-09 -0.09992805966816987 +2.61 0.7069802302555908 0.7069790390102677 8.652804242212375e-09 -0.09992808151444511 +2.6101000000000005 0.7069802694369163 0.706979077057626 9.548596888002414e-09 -0.09992810335408864 +2.6102000000000003 0.7069803086159854 0.7069791150837923 1.0431974640026653e-08 -0.09992812518710242 +2.6103 0.7069803477926659 0.7069791530889067 1.1302737482066227e-08 -0.09992814701348852 +2.6104000000000003 0.7069803869668234 0.7069791910731101 1.2160688370350947e-08 -0.09992816883324895 +2.6105 0.7069804261383217 0.7069792290365466 1.300563327345794e-08 -0.09992819064638575 +2.6106000000000003 0.7069804653070217 0.7069792669793615 1.3837381227822798e-08 -0.09992821245290084 +2.6107000000000005 0.7069805044727833 0.7069793049017024 1.4655744362025713e-08 -0.09992823425279629 +2.6108000000000002 0.7069805436354637 0.7069793428037188 1.5460537954904707e-08 -0.099928256046074 +2.6109 0.7069805827949187 0.7069793806855624 1.625158047371955e-08 -0.09992827783273615 +2.611 0.7069806219510018 0.706979418547387 1.7028693602774703e-08 -0.09992829961278461 +2.6111000000000004 0.7069806611035648 0.7069794563893474 1.7791702304134627e-08 -0.09992832138622149 +2.6112 0.7069807002524577 0.7069794942116014 1.8540434841042563e-08 -0.09992834315304874 +2.6113000000000004 0.7069807393975285 0.7069795320143075 1.9274722825625423e-08 -0.09992836491326836 +2.6114 0.7069807785386235 0.7069795697976267 1.9994401246649363e-08 -0.09992838666688239 +2.6115 0.7069808176755872 0.7069796075617212 2.069930852242885e-08 -0.09992840841389275 +2.6116 0.7069808568082627 0.7069796453067554 2.138928652251071e-08 -0.09992843015430156 +2.6117000000000004 0.7069808959364914 0.7069796830328949 2.2064180601501227e-08 -0.09992845188811073 +2.6118 0.7069809350601125 0.7069797207403077 2.2723839653709943e-08 -0.09992847361532227 +2.6119 0.7069809741789643 0.7069797584291622 2.3368116126160077e-08 -0.09992849533593823 +2.612 0.7069810132928835 0.7069797960996291 2.399686606022189e-08 -0.09992851704996059 +2.6121000000000003 0.7069810524017053 0.7069798337518807 2.4609949121970343e-08 -0.09992853875739136 +2.6122 0.7069810915052626 0.7069798713860902 2.5207228630808043e-08 -0.09992856045823251 +2.6123000000000003 0.7069811306033879 0.7069799090024329 2.578857160283332e-08 -0.09992858215248608 +2.6124 0.7069811696959121 0.7069799466010847 2.6353848759513854e-08 -0.09992860384015403 +2.6125 0.7069812087826641 0.7069799841822234 2.6902934579728366e-08 -0.09992862552123837 +2.6126000000000005 0.7069812478634725 0.7069800217460283 2.743570730323608e-08 -0.09992864719574107 +2.6127000000000002 0.706981286938164 0.7069800592926793 2.7952048972310073e-08 -0.0999286688636642 +2.6128 0.706981326006564 0.7069800968223582 2.8451845461227587e-08 -0.09992869052500974 +2.6129000000000002 0.7069813650684973 0.7069801343352471 2.8934986493617254e-08 -0.09992871217977962 +2.613 0.7069814041237872 0.7069801718315301 2.940136566847995e-08 -0.09992873382797592 +2.6131 0.7069814431722554 0.7069802093113919 2.985088047927076e-08 -0.09992875546960056 +2.6132000000000004 0.7069814822137235 0.7069802467750181 3.028343234685871e-08 -0.09992877710465549 +2.6133 0.7069815212480115 0.7069802842225963 3.0698926628200396e-08 -0.09992879873314287 +2.6134 0.706981560274939 0.7069803216543138 3.109727265103446e-08 -0.09992882035506458 +2.6135 0.7069815992943235 0.7069803590703598 3.1478383719085734e-08 -0.0999288419704226 +2.6136000000000004 0.7069816383059829 0.7069803964709237 3.184217714502502e-08 -0.09992886357921897 +2.6137 0.7069816773097335 0.706980433856196 3.218857425914268e-08 -0.09992888518145562 +2.6138000000000003 0.7069817163053913 0.7069804712263681 3.251750043363477e-08 -0.09992890677713463 +2.6139 0.7069817552927711 0.7069805085816322 3.2828885077398895e-08 -0.09992892836625794 +2.614 0.706981794271687 0.706980545922181 3.3122661679402254e-08 -0.09992894994882752 +2.6141000000000005 0.7069818332419526 0.7069805832482077 3.3398767813885843e-08 -0.09992897152484537 +2.6142000000000003 0.7069818722033812 0.7069806205599063 3.365714513862972e-08 -0.09992899309431344 +2.6143 0.7069819111557851 0.7069806578574719 3.3897739433116914e-08 -0.09992901465723382 +2.6144000000000003 0.7069819500989761 0.7069806951410993 3.412050058118621e-08 -0.09992903621360844 +2.6145 0.7069819890327658 0.706980732410984 3.432538260225715e-08 -0.09992905776343924 +2.6146000000000003 0.7069820279569649 0.7069807696673225 3.4512343660003664e-08 -0.09992907930672826 +2.6147000000000005 0.7069820668713839 0.7069808069103107 3.4681346055415174e-08 -0.09992910084347745 +2.6148000000000002 0.706982105775833 0.7069808441401461 3.483235625108272e-08 -0.0999291223736888 +2.6149 0.7069821446701223 0.7069808813570253 3.496534485732117e-08 -0.09992914389736435 +2.615 0.7069821835540615 0.7069809185611462 3.508028666512897e-08 -0.09992916541450603 +2.6151000000000004 0.7069822224274598 0.7069809557527061 3.5177160627106185e-08 -0.09992918692511589 +2.6152 0.7069822612901263 0.7069809929319026 3.525594987133229e-08 -0.09992920842919577 +2.6153000000000004 0.7069823001418702 0.7069810300989339 3.531664171524396e-08 -0.09992922992674774 +2.6154 0.7069823389825005 0.7069810672539978 3.5359227637879465e-08 -0.09992925141777378 +2.6155 0.7069823778118263 0.7069811043972924 3.538370330589957e-08 -0.09992927290227582 +2.6156 0.7069824166296564 0.7069811415290161 3.5390068557974996e-08 -0.09992929438025598 +2.6157000000000004 0.7069824554358002 0.7069811786493665 3.53783274186642e-08 -0.09992931585171612 +2.6158 0.7069824942300662 0.7069812157585416 3.534848809320923e-08 -0.09992933731665822 +2.6159 0.706982533012264 0.706981252856739 3.530056294324957e-08 -0.09992935877508427 +2.616 0.7069825717822033 0.7069812899441563 3.5234568509373565e-08 -0.09992938022699628 +2.6161000000000003 0.7069826105396932 0.7069813270209909 3.515052549030173e-08 -0.09992940167239621 +2.6162 0.7069826492845441 0.70698136408744 3.5048458742886757e-08 -0.09992942311128603 +2.6163000000000003 0.7069826880165662 0.7069814011436999 3.492839728384822e-08 -0.09992944454366769 +2.6164 0.7069827267355697 0.7069814381899673 3.4790374253343415e-08 -0.09992946596954316 +2.6165 0.7069827654413658 0.7069814752264381 3.4634426942722896e-08 -0.09992948738891445 +2.6166000000000005 0.7069828041337662 0.7069815122533077 3.446059676677493e-08 -0.09992950880178351 +2.6167000000000002 0.7069828428125828 0.7069815492707713 3.426892923423519e-08 -0.09992953020815232 +2.6168 0.7069828814776281 0.7069815862790232 3.40594739668687e-08 -0.09992955160802287 +2.6169000000000002 0.706982920128715 0.7069816232782575 3.383228468385735e-08 -0.09992957300139713 +2.617 0.7069829587656575 0.7069816602686672 3.35874191601665e-08 -0.09992959438827703 +2.6171 0.7069829973882698 0.706981697250445 3.332493924909641e-08 -0.09992961576866456 +2.6172000000000004 0.706983035996367 0.7069817342237827 3.304491083370997e-08 -0.09992963714256171 +2.6173 0.7069830745897651 0.7069817711888717 3.274740383030217e-08 -0.09992965850997047 +2.6174 0.7069831131682807 0.7069818081459021 3.2432492164113924e-08 -0.09992967987089275 +2.6175 0.7069831517317311 0.706981845095063 3.210025376239323e-08 -0.09992970122533053 +2.6176000000000004 0.7069831902799351 0.7069818820365437 3.175077051796593e-08 -0.0999297225732858 +2.6177 0.7069832288127116 0.7069819189705311 3.138412827188852e-08 -0.0999297439147605 +2.6178000000000003 0.706983267329881 0.7069819558972121 3.100041681518284e-08 -0.0999297652497566 +2.6179 0.7069833058312647 0.7069819928167731 3.059972982291659e-08 -0.09992978657827613 +2.618 0.7069833443166852 0.7069820297293978 3.018216488022418e-08 -0.09992980790032101 +2.6181000000000005 0.7069833827859655 0.7069820666352702 2.974782342853033e-08 -0.09992982921589315 +2.6182000000000003 0.7069834212389304 0.7069821035345722 2.9296810744733337e-08 -0.09992985052499456 +2.6183 0.7069834596754059 0.7069821404274853 2.8829235932531505e-08 -0.0999298718276272 +2.6184000000000003 0.7069834980952185 0.7069821773141893 2.8345211866911968e-08 -0.09992989312379304 +2.6185 0.7069835364981968 0.7069822141948634 2.7844855187211803e-08 -0.09992991441349407 +2.6186000000000003 0.7069835748841702 0.7069822510696845 2.732828626589301e-08 -0.0999299356967322 +2.6187000000000005 0.7069836132529697 0.7069822879388288 2.67956291859911e-08 -0.09992995697350941 +2.6188000000000002 0.7069836516044272 0.706982324802471 2.6247011697747014e-08 -0.09992997824382766 +2.6189 0.7069836899383766 0.7069823616607844 2.5682565196055718e-08 -0.09992999950768887 +2.619 0.7069837282546532 0.7069823985139408 2.5102424687506453e-08 -0.09993002076509507 +2.6191000000000004 0.7069837665530933 0.7069824353621105 2.450672875742299e-08 -0.09993004201604817 +2.6192 0.7069838048335353 0.7069824722054622 2.3895619535169166e-08 -0.09993006326055015 +2.6193 0.7069838430958186 0.7069825090441634 2.326924266292385e-08 -0.099930084498603 +2.6194 0.7069838813397848 0.7069825458783792 2.262774726792538e-08 -0.09993010573020858 +2.6195 0.7069839195652766 0.7069825827082739 2.1971285912164573e-08 -0.09993012695536889 +2.6196 0.7069839577721391 0.7069826195340099 2.1300014569833325e-08 -0.09993014817408592 +2.6197000000000004 0.7069839959602182 0.7069826563557475 2.0614092581354437e-08 -0.09993016938636162 +2.6198 0.7069840341293622 0.7069826931736456 1.9913682612615613e-08 -0.09993019059219792 +2.6199 0.7069840722794211 0.7069827299878612 1.9198950633285417e-08 -0.09993021179159678 +2.62 0.7069841104102463 0.7069827667985494 1.847006585609795e-08 -0.09993023298456015 +2.6201000000000003 0.7069841485216914 0.7069828036058634 1.7727200710832003e-08 -0.09993025417108992 +2.6202 0.7069841866136124 0.7069828404099551 1.697053080441241e-08 -0.09993027535118813 +2.6203000000000003 0.7069842246858664 0.7069828772109739 1.620023487060307e-08 -0.09993029652485677 +2.6204 0.7069842627383125 0.7069829140090669 1.5416494737047204e-08 -0.09993031769209769 +2.6205 0.7069843007708122 0.7069829508043802 1.4619495271490923e-08 -0.09993033885291287 +2.6206000000000005 0.7069843387832289 0.7069829875970571 1.3809424343619314e-08 -0.09993036000730426 +2.6207000000000003 0.7069843767754278 0.706983024387239 1.2986472789494607e-08 -0.0999303811552738 +2.6208 0.7069844147472767 0.7069830611750657 1.2150834352575579e-08 -0.0999304022968235 +2.6209000000000002 0.7069844526986451 0.7069830979606742 1.1302705643818911e-08 -0.09993042343195524 +2.621 0.7069844906294045 0.7069831347441994 1.0442286100045828e-08 -0.09993044456067096 +2.6211 0.7069845285394292 0.7069831715257744 9.569777932767753e-09 -0.09993046568297263 +2.6212000000000004 0.7069845664285953 0.7069832083055301 8.68538607701197e-09 -0.09993048679886223 +2.6213 0.7069846042967812 0.7069832450835949 7.789318151422975e-09 -0.09993050790834168 +2.6214 0.7069846421438675 0.706983281860095 6.881784393210355e-09 -0.09993052901141292 +2.6215 0.706984679969737 0.7069833186351544 5.962997639934187e-09 -0.09993055010807789 +2.6216000000000004 0.7069847177742751 0.7069833554088947 5.0331732462383094e-09 -0.09993057119833852 +2.6217 0.7069847555573692 0.7069833921814351 4.0925290526253044e-09 -0.09993059228219674 +2.6218000000000004 0.7069847933189093 0.7069834289528929 3.1412853325474277e-09 -0.09993061335965456 +2.6219 0.7069848310587878 0.7069834657233822 2.179664730823927e-09 -0.09993063443071387 +2.622 0.7069848687768996 0.7069835024930153 1.2078922211403165e-09 -0.09993065549537666 +2.6221000000000005 0.7069849064731419 0.7069835392619019 2.2619505313931088e-10 -0.09993067655364485 +2.6222000000000003 0.7069849441474142 0.706983576030149 -7.651973039576876e-10 -0.09993069760552031 +2.6223 0.7069849817996187 0.7069836127978613 -1.7660532142596552e-09 -0.09993071865100504 +2.6224000000000003 0.70698501942966 0.7069836495651411 -2.776138927247651e-09 -0.09993073969010097 +2.6225 0.7069850570374454 0.7069836863320882 -3.795218638490139e-09 -0.09993076072281006 +2.6226000000000003 0.7069850946228848 0.7069837230987993 -4.82305453648052e-09 -0.09993078174913421 +2.6227000000000005 0.7069851321858904 0.7069837598653692 -5.8594068633524565e-09 -0.09993080276907539 +2.6228000000000002 0.7069851697263773 0.7069837966318897 -6.904033967788936e-09 -0.0999308237826355 +2.6229 0.7069852072442628 0.7069838333984497 -7.956692365737594e-09 -0.0999308447898165 +2.623 0.7069852447394674 0.7069838701651365 -9.017136790717695e-09 -0.09993086579062033 +2.6231000000000004 0.706985282211914 0.7069839069320337 -1.0085120259739622e-08 -0.09993088678504891 +2.6232 0.706985319661528 0.7069839436992229 -1.116039411797401e-08 -0.0999309077731042 +2.6233 0.7069853570882374 0.7069839804667823 -1.2242708111610129e-08 -0.0999309287547881 +2.6234 0.7069853944919733 0.7069840172347883 -1.3331810432958696e-08 -0.09993094973010257 +2.6235 0.7069854318726693 0.7069840540033137 -1.4427447788539771e-08 -0.09993097069904948 +2.6236 0.7069854692302618 0.7069840907724287 -1.5529365453292865e-08 -0.0999309916616308 +2.6237000000000004 0.7069855065646902 0.7069841275422017 -1.6637307328690176e-08 -0.09993101261784854 +2.6238 0.7069855438758962 0.7069841643126973 -1.775101600692136e-08 -0.09993103356770454 +2.6239 0.7069855811638244 0.7069842010839777 -1.8870232825971e-08 -0.09993105451120075 +2.624 0.7069856184284224 0.706984237856102 -1.999469793163497e-08 -0.09993107544833908 +2.6241000000000003 0.7069856556696404 0.7069842746291268 -2.112415033736839e-08 -0.09993109637912148 +2.6242 0.7069856928874315 0.706984311403106 -2.2258327986735688e-08 -0.09993111730354987 +2.6243000000000003 0.7069857300817519 0.7069843481780906 -2.3396967813258535e-08 -0.09993113822162622 +2.6244 0.7069857672525599 0.7069843849541286 -2.4539805799396464e-08 -0.09993115913335243 +2.6245 0.7069858043998175 0.706984421731265 -2.5686577037695862e-08 -0.09993118003873042 +2.6246000000000005 0.7069858415234889 0.7069844585095422 -2.6837015796709468e-08 -0.09993120093776207 +2.6247000000000003 0.7069858786235417 0.7069844952889996 -2.799085557715804e-08 -0.09993122183044939 +2.6248 0.7069859156999456 0.7069845320696742 -2.9147829177199325e-08 -0.09993124271679422 +2.6249000000000002 0.7069859527526744 0.7069845688515993 -3.030766875401075e-08 -0.0999312635967986 +2.625 0.7069859897817035 0.7069846056348063 -3.1470105883637384e-08 -0.09993128447046438 +2.6251 0.7069860267870118 0.7069846424193225 -3.263487162409248e-08 -0.09993130533779344 +2.6252000000000004 0.706986063768581 0.7069846792051734 -3.380169657542231e-08 -0.09993132619878775 +2.6253 0.706986100726396 0.706984715992381 -3.4970310949528766e-08 -0.09993134705344926 +2.6254 0.706986137660444 0.7069847527809645 -3.6140444622969996e-08 -0.0999313679017798 +2.6255 0.706986174570716 0.7069847895709405 -3.731182720721673e-08 -0.09993138874378142 +2.6256000000000004 0.706986211457205 0.7069848263623222 -3.848418810297079e-08 -0.09993140957945595 +2.6257 0.7069862483199069 0.7069848631551203 -3.9657256572101906e-08 -0.09993143040880532 +2.6258000000000004 0.7069862851588212 0.7069848999493424 -4.08307617921831e-08 -0.09993145123183149 +2.6259 0.7069863219739501 0.7069849367449932 -4.2004432922627e-08 -0.09993147204853631 +2.626 0.7069863587652983 0.7069849735420743 -4.317799916804391e-08 -0.09993149285892172 +2.6261000000000005 0.7069863955328741 0.706985010340585 -4.4351189837629e-08 -0.0999315136629897 +2.6262000000000003 0.7069864322766878 0.7069850471405212 -4.552373441077005e-08 -0.09993153446074216 +2.6263 0.7069864689967532 0.7069850839418758 -4.669536259716651e-08 -0.0999315552521809 +2.6264000000000003 0.7069865056930871 0.7069851207446389 -4.786580439972675e-08 -0.0999315760373079 +2.6265 0.7069865423657089 0.7069851575487981 -4.9034790176828366e-08 -0.09993159681612512 +2.6266000000000003 0.706986579014641 0.7069851943543376 -5.020205070421259e-08 -0.09993161758863446 +2.6267000000000005 0.7069866156399085 0.7069852311612391 -5.136731723743432e-08 -0.09993163835483783 +2.6268000000000002 0.7069866522415398 0.706985267969481 -5.253032157458322e-08 -0.0999316591147371 +2.6269 0.7069866888195653 0.7069853047790392 -5.3690796116131687e-08 -0.09993167986833418 +2.627 0.7069867253740195 0.7069853415898866 -5.484847392543332e-08 -0.099931700615631 +2.6271000000000004 0.706986761904939 0.7069853784019929 -5.600308879442559e-08 -0.0999317213566295 +2.6272 0.7069867984123632 0.7069854152153259 -5.715437530130936e-08 -0.09993174209133156 +2.6273 0.7069868348963348 0.7069854520298495 -5.8302068872348456e-08 -0.09993176281973914 +2.6274 0.7069868713568987 0.7069854888455254 -5.9445905843452315e-08 -0.0999317835418541 +2.6275 0.7069869077941032 0.7069855256623123 -6.058562352067448e-08 -0.09993180425767835 +2.6276 0.7069869442079991 0.7069855624801659 -6.1720960238109e-08 -0.09993182496721381 +2.6277000000000004 0.7069869805986401 0.7069855992990393 -6.285165542012361e-08 -0.09993184567046237 +2.6278 0.7069870169660826 0.7069856361188827 -6.397744964359298e-08 -0.09993186636742594 +2.6279 0.7069870533103858 0.706985672939644 -6.509808468885617e-08 -0.09993188705810647 +2.628 0.7069870896316119 0.7069857097612677 -6.621330361040664e-08 -0.09993190774250588 +2.6281000000000003 0.7069871259298253 0.706985746583696 -6.73228507880666e-08 -0.09993192842062597 +2.6282 0.7069871622050936 0.7069857834068678 -6.842647198683494e-08 -0.0999319490924687 +2.6283000000000003 0.7069871984574871 0.70698582023072 -6.95239144167352e-08 -0.09993196975803599 +2.6284 0.7069872346870785 0.7069858570551864 -7.061492678789305e-08 -0.09993199041732975 +2.6285 0.7069872708939435 0.7069858938801981 -7.169925937168531e-08 -0.09993201107035185 +2.6286000000000005 0.7069873070781603 0.7069859307056838 -7.277666405581737e-08 -0.09993203171710426 +2.6287000000000003 0.7069873432398094 0.7069859675315693 -7.384689440070175e-08 -0.09993205235758879 +2.6288 0.7069873793789745 0.7069860043577779 -7.49097056975713e-08 -0.09993207299180738 +2.6289000000000002 0.7069874154957418 0.7069860411842301 -7.596485502442407e-08 -0.09993209361976196 +2.629 0.7069874515901998 0.7069860780108443 -7.701210129416186e-08 -0.09993211424145441 +2.6291 0.7069874876624398 0.7069861148375358 -7.805120532354548e-08 -0.09993213485688664 +2.6292000000000004 0.7069875237125555 0.7069861516642175 -7.908192987699653e-08 -0.09993215546606055 +2.6293 0.7069875597406432 0.7069861884908 -8.010403972254221e-08 -0.09993217606897802 +2.6294 0.7069875957468017 0.7069862253171906 -8.11173016873265e-08 -0.09993219666564088 +2.6295 0.7069876317311323 0.7069862621432955 -8.212148471485603e-08 -0.09993221725605117 +2.6296000000000004 0.7069876676937387 0.7069862989690174 -8.311635990316396e-08 -0.09993223784021069 +2.6297 0.706987703634727 0.706986335794257 -8.410170057593369e-08 -0.09993225841812135 +2.6298000000000004 0.7069877395542057 0.7069863726189121 -8.507728232586692e-08 -0.09993227898978506 +2.6299 0.7069877754522861 0.7069864094428788 -8.604288305198021e-08 -0.09993229955520375 +2.63 0.706987811329081 0.7069864462660502 -8.699828303940227e-08 -0.0999323201143792 +2.6301000000000005 0.7069878471847062 0.7069864830883179 -8.794326498366006e-08 -0.09993234066731345 +2.6302000000000003 0.7069878830192797 0.7069865199095703 -8.887761405139416e-08 -0.0999323612140083 +2.6303 0.7069879188329218 0.7069865567296938 -8.980111792632889e-08 -0.09993238175446567 +2.6304000000000003 0.7069879546257547 0.7069865935485731 -9.071356685697723e-08 -0.09993240228868745 +2.6305 0.7069879903979033 0.7069866303660898 -9.161475371128464e-08 -0.09993242281667554 +2.6306000000000003 0.7069880261494941 0.7069866671821237 -9.250447401305817e-08 -0.0999324433384318 +2.6307000000000005 0.7069880618806565 0.7069867039965527 -9.338252599661034e-08 -0.09993246385395817 +2.6308000000000002 0.7069880975915215 0.7069867408092525 -9.424871064665774e-08 -0.09993248436325652 +2.6309 0.7069881332822223 0.7069867776200963 -9.510283174515854e-08 -0.09993250486632872 +2.631 0.7069881689528945 0.7069868144289552 -9.594469591901744e-08 -0.09993252536317668 +2.6311000000000004 0.7069882046036753 0.7069868512356989 -9.677411267738217e-08 -0.09993254585380229 +2.6312 0.7069882402347036 0.7069868880401945 -9.759089446541996e-08 -0.09993256633820738 +2.6313 0.7069882758461215 0.7069869248423074 -9.839485669554254e-08 -0.09993258681639389 +2.6314 0.7069883114380717 0.7069869616419011 -9.918581778730479e-08 -0.09993260728836373 +2.6315 0.7069883470106999 0.7069869984388368 -9.996359922465059e-08 -0.09993262775411874 +2.6316 0.7069883825641528 0.7069870352329746 -1.00728025580199e-07 -0.09993264821366085 +2.6317000000000004 0.7069884180985797 0.7069870720241715 -1.0147892456381646e-07 -0.09993266866699191 +2.6318 0.7069884536141309 0.7069871088122839 -1.0221612705644395e-07 -0.09993268911411374 +2.6319 0.7069884891109592 0.7069871455971658 -1.0293946714912822e-07 -0.09993270955502837 +2.632 0.7069885245892189 0.7069871823786698 -1.0364878218205309e-07 -0.0999327299897376 +2.6321000000000003 0.7069885600490657 0.7069872191566464 -1.0434391278183602e-07 -0.09993275041824332 +2.6322 0.7069885954906575 0.7069872559309448 -1.0502470289275312e-07 -0.09993277084054741 +2.6323000000000003 0.7069886309141533 0.7069872927014123 -1.0569099981490304e-07 -0.09993279125665173 +2.6324 0.706988666319714 0.7069873294678944 -1.0634265423456468e-07 -0.09993281166655817 +2.6325 0.7069887017075024 0.7069873662302357 -1.0697952027363677e-07 -0.09993283207026865 +2.6326000000000005 0.7069887370776822 0.7069874029882788 -1.0760145549570943e-07 -0.09993285246778502 +2.6327000000000003 0.7069887724304187 0.7069874397418652 -1.0820832095637112e-07 -0.0999328728591092 +2.6328 0.7069888077658788 0.7069874764908344 -1.0879998123096424e-07 -0.09993289324424304 +2.6329000000000002 0.706988843084231 0.7069875132350245 -1.0937630444927959e-07 -0.09993291362318837 +2.633 0.7069888783856446 0.7069875499742728 -1.0993716230423001e-07 -0.09993293399594713 +2.6331 0.7069889136702909 0.706987586708415 -1.1048243010736147e-07 -0.09993295436252116 +2.6332000000000004 0.7069889489383423 0.7069876234372854 -1.1101198680099622e-07 -0.09993297472291235 +2.6333 0.7069889841899719 0.7069876601607169 -1.1152571498772301e-07 -0.09993299507712261 +2.6334 0.7069890194253549 0.7069876968785416 -1.1202350096162217e-07 -0.09993301542515376 +2.6335 0.7069890546446669 0.7069877335905903 -1.1250523471867391e-07 -0.0999330357670077 +2.6336000000000004 0.7069890898480848 0.7069877702966922 -1.1297081000359588e-07 -0.0999330561026863 +2.6337 0.7069891250357875 0.706987806996676 -1.1342012431331261e-07 -0.09993307643219144 +2.6338000000000004 0.7069891602079533 0.7069878436903692 -1.1385307892991525e-07 -0.09993309675552497 +2.6339 0.706989195364763 0.7069878803775982 -1.1426957893106993e-07 -0.09993311707268882 +2.634 0.7069892305063976 0.7069879170581883 -1.1466953323165108e-07 -0.09993313738368478 +2.6341000000000006 0.7069892656330392 0.706987953731964 -1.1505285458374148e-07 -0.09993315768851477 +2.6342000000000003 0.7069893007448709 0.706987990398749 -1.1541945960612254e-07 -0.09993317798718067 +2.6343 0.7069893358420765 0.7069880270583659 -1.157692687998868e-07 -0.09993319827968432 +2.6344000000000003 0.7069893709248407 0.7069880637106369 -1.1610220655711156e-07 -0.0999332185660276 +2.6345 0.7069894059933488 0.7069881003553831 -1.1641820119034918e-07 -0.09993323884621239 +2.6346000000000003 0.706989441047787 0.7069881369924249 -1.1671718494130068e-07 -0.09993325912024056 +2.6347000000000005 0.7069894760883422 0.7069881736215822 -1.1699909400510189e-07 -0.09993327938811392 +2.6348000000000003 0.7069895111152018 0.7069882102426739 -1.1726386851818038e-07 -0.09993329964983443 +2.6349 0.7069895461285538 0.7069882468555189 -1.1751145260162355e-07 -0.0999333199054039 +2.635 0.7069895811285869 0.7069882834599348 -1.1774179434730081e-07 -0.09993334015482418 +2.6351000000000004 0.70698961611549 0.7069883200557395 -1.1795484585776228e-07 -0.09993336039809719 +2.6352 0.7069896510894533 0.70698835664275 -1.1815056322195261e-07 -0.0999333806352248 +2.6353 0.7069896860506658 0.7069883932207826 -1.1832890654643602e-07 -0.09993340086620879 +2.6354 0.7069897209993186 0.7069884297896537 -1.1848983995886575e-07 -0.0999334210910511 +2.6355 0.7069897559356018 0.7069884663491792 -1.1863333161665768e-07 -0.09993344130975354 +2.6356 0.7069897908597067 0.7069885028991747 -1.1875935371045976e-07 -0.09993346152231797 +2.6357000000000004 0.7069898257718247 0.7069885394394557 -1.1886788245894786e-07 -0.09993348172874633 +2.6358 0.7069898606721472 0.7069885759698373 -1.1895889812790772e-07 -0.09993350192904045 +2.6359 0.7069898955608658 0.7069886124901341 -1.1903238503890856e-07 -0.09993352212320217 +2.636 0.7069899304381722 0.7069886490001613 -1.1908833155195586e-07 -0.09993354231123334 +2.6361000000000003 0.7069899653042578 0.7069886854997337 -1.1912673008457331e-07 -0.09993356249313584 +2.6362 0.7069900001593149 0.7069887219886659 -1.1914757709619028e-07 -0.0999335826689115 +2.6363000000000003 0.7069900350035354 0.7069887584667729 -1.1915087309855021e-07 -0.09993360283856226 +2.6364 0.7069900698371107 0.7069887949338691 -1.1913662265571057e-07 -0.0999336230020899 +2.6365 0.7069901046602326 0.7069888313897701 -1.1910483437883868e-07 -0.09993364315949632 +2.6366000000000005 0.7069901394730926 0.7069888678342904 -1.1905552091753813e-07 -0.09993366331078338 +2.6367000000000003 0.706990174275882 0.7069889042672451 -1.1898869896505293e-07 -0.09993368345595285 +2.6368 0.706990209068792 0.7069889406884502 -1.1890438923745084e-07 -0.0999337035950067 +2.6369000000000002 0.7069902438520133 0.7069889770977211 -1.1880261649097057e-07 -0.09993372372794673 +2.637 0.7069902786257364 0.706989013494874 -1.186834094977357e-07 -0.09993374385477477 +2.6371 0.7069903133901514 0.7069890498797253 -1.1854680103881576e-07 -0.09993376397549272 +2.6372000000000004 0.7069903481454483 0.706989086252092 -1.1839282791116512e-07 -0.09993378409010245 +2.6373 0.706990382891816 0.7069891226117909 -1.1822153089986742e-07 -0.09993380419860576 +2.6374 0.7069904176294436 0.70698915895864 -1.1803295477466613e-07 -0.09993382430100449 +2.6375 0.7069904523585192 0.7069891952924576 -1.1782714827435203e-07 -0.09993384439730055 +2.6376000000000004 0.7069904870792305 0.7069892316130628 -1.1760416410155905e-07 -0.09993386448749575 +2.6377 0.7069905217917647 0.7069892679202747 -1.1736405891062118e-07 -0.099933884571592 +2.6378000000000004 0.7069905564963084 0.7069893042139135 -1.1710689327287804e-07 -0.09993390464959108 +2.6379 0.706990591193047 0.7069893404937999 -1.1683273169402209e-07 -0.09993392472149487 +2.638 0.7069906258821654 0.7069893767597555 -1.1654164257419997e-07 -0.09993394478730518 +2.6381000000000006 0.7069906605638481 0.7069894130116031 -1.1623369818546114e-07 -0.09993396484702394 +2.6382000000000003 0.7069906952382783 0.7069894492491655 -1.1590897468390093e-07 -0.09993398490065294 +2.6383 0.7069907299056385 0.7069894854722669 -1.1556755206802716e-07 -0.09993400494819407 +2.6384000000000003 0.7069907645661104 0.7069895216807319 -1.1520951416488234e-07 -0.09993402498964915 +2.6385 0.7069907992198747 0.7069895578743866 -1.148349486126965e-07 -0.09993404502502 +2.6386000000000003 0.7069908338671109 0.7069895940530577 -1.1444394682272319e-07 -0.09993406505430848 +2.6387000000000005 0.7069908685079977 0.7069896302165734 -1.1403660397577009e-07 -0.09993408507751646 +2.6388000000000003 0.7069909031427131 0.7069896663647625 -1.1361301899617815e-07 -0.09993410509464581 +2.6389 0.7069909377714327 0.706989702497455 -1.1317329453273961e-07 -0.09993412510569832 +2.639 0.7069909723943324 0.7069897386144823 -1.127175369135952e-07 -0.09993414511067583 +2.6391000000000004 0.7069910070115859 0.7069897747156765 -1.122458561340911e-07 -0.0999341651095802 +2.6392 0.7069910416233665 0.7069898108008716 -1.1175836584290111e-07 -0.09993418510241328 +2.6393 0.7069910762298455 0.7069898468699024 -1.1125518327957662e-07 -0.09993420508917693 +2.6394 0.7069911108311935 0.7069898829226049 -1.107364292866897e-07 -0.09993422506987293 +2.6395 0.7069911454275792 0.706989918958817 -1.1020222825432191e-07 -0.09993424504450323 +2.6396 0.7069911800191704 0.7069899549783771 -1.0965270809924765e-07 -0.09993426501306953 +2.6397000000000004 0.706991214606133 0.7069899909811258 -1.090880002389133e-07 -0.09993428497557372 +2.6398 0.706991249188632 0.7069900269669049 -1.0850823954459965e-07 -0.09993430493201766 +2.6399 0.7069912837668303 0.7069900629355578 -1.079135643292789e-07 -0.09993432488240316 +2.64 0.70699131834089 0.7069900988869293 -1.0730411629470554e-07 -0.09993434482673214 +2.6401000000000003 0.706991352910971 0.7069901348208657 -1.0668004051233443e-07 -0.09993436476500639 +2.6402 0.7069913874772319 0.7069901707372148 -1.0604148538428948e-07 -0.0999343846972277 +2.6403000000000003 0.7069914220398296 0.7069902066358267 -1.0538860261040395e-07 -0.09993440462339798 +2.6404 0.706991456598919 0.7069902425165521 -1.0472154714658705e-07 -0.09993442454351899 +2.6405 0.706991491154654 0.7069902783792443 -1.0404047717273157e-07 -0.09993444445759263 +2.6406000000000005 0.7069915257071864 0.7069903142237579 -1.0334555405021317e-07 -0.0999344643656207 +2.6407000000000003 0.7069915602566659 0.7069903500499495 -1.0263694229066533e-07 -0.09993448426760507 +2.6408 0.7069915948032408 0.7069903858576772 -1.0191480951261128e-07 -0.0999345041635475 +2.6409000000000002 0.7069916293470577 0.7069904216468013 -1.0117932640156535e-07 -0.09993452405344992 +2.641 0.7069916638882607 0.7069904574171836 -1.0043066667707323e-07 -0.09993454393731405 +2.6411000000000002 0.7069916984269927 0.7069904931686883 -9.966900703633347e-08 -0.09993456381514182 +2.6412000000000004 0.7069917329633941 0.7069905289011811 -9.889452712644187e-08 -0.09993458368693503 +2.6413 0.7069917674976041 0.7069905646145296 -9.810740949842134e-08 -0.09993460355269554 +2.6414 0.7069918020297588 0.706990600308604 -9.73078395638538e-08 -0.09993462341242514 +2.6415 0.706991836559993 0.7069906359832757 -9.649600555064475e-08 -0.09993464326612565 +2.6416000000000004 0.7069918710884393 0.7069906716384187 -9.567209845792041e-08 -0.0999346631137989 +2.6417 0.7069919056152282 0.7069907072739092 -9.483631201179232e-08 -0.09993468295544675 +2.6418000000000004 0.7069919401404883 0.706990742889625 -9.398884261678508e-08 -0.09993470279107101 +2.6419 0.7069919746643456 0.7069907784854464 -9.312988931680505e-08 -0.09993472262067353 +2.642 0.7069920091869243 0.706990814061256 -9.225965374483336e-08 -0.09993474244425612 +2.6421000000000006 0.7069920437083461 0.7069908496169379 -9.137834007782314e-08 -0.09993476226182058 +2.6422000000000003 0.7069920782287309 0.7069908851523793 -9.048615497945361e-08 -0.09993478207336876 +2.6423 0.7069921127481961 0.7069909206674689 -8.958330756543564e-08 -0.09993480187890247 +2.6424000000000003 0.7069921472668567 0.7069909561620986 -8.86700093427964e-08 -0.09993482167842359 +2.6425 0.7069921817848255 0.7069909916361616 -8.774647416651127e-08 -0.09993484147193392 +2.6426000000000003 0.7069922163022132 0.706991027089554 -8.681291819093162e-08 -0.09993486125943524 +2.6427000000000005 0.7069922508191278 0.7069910625221737 -8.586955980993682e-08 -0.09993488104092939 +2.6428000000000003 0.7069922853356749 0.7069910979339218 -8.491661962310715e-08 -0.0999349008164182 +2.6429 0.7069923198519583 0.7069911333247013 -8.395432036633482e-08 -0.09993492058590348 +2.643 0.7069923543680785 0.7069911686944177 -8.298288686672123e-08 -0.09993494034938709 +2.6431000000000004 0.7069923888841342 0.706991204042979 -8.200254599313728e-08 -0.09993496010687081 +2.6432 0.7069924234002216 0.7069912393702955 -8.101352659637545e-08 -0.09993497985835649 +2.6433 0.7069924579164342 0.7069912746762798 -8.001605946664908e-08 -0.09993499960384594 +2.6434 0.7069924924328632 0.7069913099608476 -7.901037726940757e-08 -0.09993501934334101 +2.6435 0.7069925269495968 0.7069913452239167 -7.799671449589679e-08 -0.09993503907684344 +2.6436 0.7069925614667212 0.7069913804654073 -7.69753074033111e-08 -0.09993505880435509 +2.6437000000000004 0.7069925959843198 0.706991415685243 -7.594639396361902e-08 -0.09993507852587784 +2.6438 0.7069926305024736 0.7069914508833488 -7.491021381282256e-08 -0.09993509824141339 +2.6439 0.7069926650212606 0.706991486059653 -7.386700819110928e-08 -0.0999351179509636 +2.644 0.7069926995407566 0.7069915212140863 -7.281701988213693e-08 -0.09993513765453031 +2.6441000000000003 0.7069927340610347 0.7069915563465823 -7.176049316272651e-08 -0.09993515735211532 +2.6442 0.7069927685821652 0.706991591457077 -7.069767374388164e-08 -0.09993517704372047 +2.6443000000000003 0.7069928031042159 0.706991626545509 -6.962880871441007e-08 -0.09993519672934757 +2.6444 0.7069928376272517 0.7069916616118195 -6.855414648020836e-08 -0.09993521640899837 +2.6445 0.7069928721513354 0.7069916966559526 -6.747393671308749e-08 -0.09993523608267477 +2.6446000000000005 0.7069929066765261 0.7069917316778556 -6.638843028702185e-08 -0.09993525575037854 +2.6447000000000003 0.706992941202881 0.7069917666774772 -6.529787921916858e-08 -0.09993527541211146 +2.6448 0.7069929757304545 0.7069918016547698 -6.420253661825956e-08 -0.09993529506787541 +2.6449000000000003 0.7069930102592981 0.7069918366096883 -6.310265662085035e-08 -0.09993531471767217 +2.645 0.7069930447894603 0.7069918715421907 -6.199849432887011e-08 -0.09993533436150355 +2.6451000000000002 0.7069930793209875 0.706991906452237 -6.089030576148305e-08 -0.09993535399937138 +2.6452000000000004 0.7069931138539225 0.7069919413397903 -5.977834778569946e-08 -0.09993537363127739 +2.6453 0.7069931483883062 0.7069919762048167 -5.866287805956355e-08 -0.0999353932572235 +2.6454 0.706993182924176 0.7069920110472849 -5.7544154974040196e-08 -0.09993541287721147 +2.6455 0.7069932174615668 0.7069920458671659 -5.6422437591432256e-08 -0.09993543249124302 +2.6456000000000004 0.706993252000511 0.7069920806644345 -5.529798558770102e-08 -0.09993545209932006 +2.6457 0.706993286541038 0.7069921154390678 -5.41710591891488e-08 -0.09993547170144444 +2.6458000000000004 0.706993321083174 0.7069921501910452 -5.304191911690778e-08 -0.09993549129761783 +2.6459 0.706993355626943 0.70699218492035 -5.1910826521020526e-08 -0.0999355108878422 +2.646 0.7069933901723658 0.7069922196269669 -5.077804292276042e-08 -0.09993553047211921 +2.6461000000000006 0.7069934247194605 0.7069922543108847 -4.964383015662686e-08 -0.0999355500504507 +2.6462000000000003 0.7069934592682423 0.7069922889720945 -4.850845030431733e-08 -0.09993556962283852 +2.6463 0.7069934938187239 0.7069923236105897 -4.737216563997521e-08 -0.09993558918928441 +2.6464000000000003 0.7069935283709148 0.7069923582263677 -4.6235238565408687e-08 -0.09993560874979024 +2.6465 0.7069935629248216 0.7069923928194276 -4.509793155203171e-08 -0.09993562830435775 +2.6466000000000003 0.7069935974804487 0.706992427389772 -4.396050707949819e-08 -0.09993564785298875 +2.6467 0.706993632037797 0.706992461937406 -4.282322757276401e-08 -0.0999356673956851 +2.6468000000000003 0.7069936665968652 0.7069924964623375 -4.168635534668435e-08 -0.09993568693244854 +2.6469 0.7069937011576487 0.7069925309645775 -4.055015254050072e-08 -0.09993570646328093 +2.647 0.7069937357201399 0.7069925654441397 -3.9414881061869064e-08 -0.09993572598818401 +2.6471000000000005 0.7069937702843292 0.7069925999010404 -3.828080252202444e-08 -0.09993574550715961 +2.6472 0.7069938048502036 0.7069926343352986 -3.714817817810148e-08 -0.09993576502020951 +2.6473 0.7069938394177468 0.7069926687469366 -3.601726887331354e-08 -0.09993578452733547 +2.6474 0.706993873986941 0.7069927031359792 -3.4888334975668144e-08 -0.09993580402853931 +2.6475 0.7069939085577652 0.7069927375024543 -3.3761636318878005e-08 -0.09993582352382294 +2.6476 0.7069939431301948 0.7069927718463921 -3.263743214316356e-08 -0.09993584301318807 +2.6477000000000004 0.7069939777042029 0.7069928061678256 -3.151598103150188e-08 -0.09993586249663644 +2.6478 0.7069940122797602 0.7069928404667909 -3.039754085487449e-08 -0.09993588197416992 +2.6479 0.7069940468568343 0.7069928747433265 -2.9282368714045673e-08 -0.09993590144579023 +2.648 0.7069940814353899 0.7069929089974741 -2.8170720875377725e-08 -0.09993592091149925 +2.6481000000000003 0.7069941160153892 0.7069929432292782 -2.706285271510296e-08 -0.09993594037129877 +2.6482 0.7069941505967918 0.7069929774387851 -2.5959018661210476e-08 -0.09993595982519052 +2.6483000000000003 0.7069941851795544 0.706993011626045 -2.485947213229714e-08 -0.09993597927317635 +2.6484 0.7069942197636306 0.70699304579111 -2.3764465480104885e-08 -0.09993599871525803 +2.6485 0.706994254348972 0.7069930799340349 -2.267424993466008e-08 -0.09993601815143728 +2.6486000000000005 0.7069942889355271 0.7069931140548779 -2.15890755446424e-08 -0.09993603758171599 +2.6487000000000003 0.7069943235232418 0.7069931481536992 -2.0509191119705283e-08 -0.09993605700609592 +2.6488 0.7069943581120594 0.706993182230562 -1.943484417453109e-08 -0.09993607642457886 +2.6489000000000003 0.7069943927019208 0.7069932162855318 -1.8366280867248425e-08 -0.09993609583716666 +2.649 0.7069944272927636 0.7069932503186769 -1.7303745951293553e-08 -0.09993611524386099 +2.6491000000000002 0.7069944618845232 0.7069932843300686 -1.624748271469509e-08 -0.0999361346446637 +2.6492000000000004 0.7069944964771325 0.7069933183197801 -1.5197732924996515e-08 -0.09993615403957656 +2.6493 0.7069945310705217 0.7069933522878874 -1.4154736770709275e-08 -0.09993617342860134 +2.6494 0.7069945656646186 0.7069933862344697 -1.3118732816209955e-08 -0.09993619281173989 +2.6495 0.7069946002593481 0.7069934201596078 -1.2089957932351347e-08 -0.099936212188994 +2.6496000000000004 0.706994634854633 0.7069934540633854 -1.1068647256130132e-08 -0.09993623156036535 +2.6497 0.706994669450393 0.706993487945889 -1.0055034127803147e-08 -0.09993625092585584 +2.6498000000000004 0.7069947040465461 0.706993521807207 -9.04935004448354e-09 -0.09993627028546714 +2.6499 0.706994738643007 0.7069935556474307 -8.051824602027524e-09 -0.09993628963920112 +2.65 0.7069947732396888 0.7069935894666541 -7.062685447763173e-09 -0.09993630898705957 +2.6501000000000006 0.7069948078365016 0.7069936232649727 -6.082158221509815e-09 -0.0999363283290442 +2.6502000000000003 0.7069948424333534 0.7069936570424853 -5.1104665074394595e-09 -0.09993634766515691 +2.6503 0.7069948770301497 0.7069936907992922 -4.147831786371903e-09 -0.09993636699539934 +2.6504000000000003 0.7069949116267932 0.7069937245354972 -3.194473380263574e-09 -0.09993638631977336 +2.6505 0.7069949462231853 0.7069937582512055 -2.250608407104726e-09 -0.09993640563828074 +2.6506000000000003 0.706994980819224 0.7069937919465248 -1.3164517288777322e-09 -0.09993642495092321 +2.6507 0.7069950154148059 0.7069938256215652 -3.922159029848271e-10 -0.09993644425770264 +2.6508000000000003 0.7069950500098249 0.7069938592764393 5.218888697935964e-10 -0.09993646355862074 +2.6509 0.7069950846041724 0.7069938929112614 1.4256547851976276e-09 -0.09993648285367927 +2.651 0.7069951191977384 0.7069939265261482 2.3188764918663507e-09 -0.09993650214288007 +2.6511000000000005 0.70699515379041 0.7069939601212187 3.201351125164953e-09 -0.09993652142622489 +2.6512000000000002 0.7069951883820722 0.706993993696594 4.072878369634769e-09 -0.09993654070371544 +2.6513 0.7069952229726089 0.7069940272523974 4.933260491953029e-09 -0.09993655997535365 +2.6514 0.7069952575619001 0.7069940607887542 5.78230238863775e-09 -0.09993657924114117 +2.6515 0.7069952921498255 0.7069940943057913 6.619811634619999e-09 -0.09993659850107983 +2.6516 0.7069953267362619 0.7069941278036387 7.445598523142527e-09 -0.09993661775517143 +2.6517000000000004 0.7069953613210835 0.7069941612824273 8.259476104791053e-09 -0.09993663700341765 +2.6518 0.7069953959041639 0.7069941947422906 9.061260240403324e-09 -0.09993665624582032 +2.6519 0.706995430485374 0.7069942281833639 9.850769628824696e-09 -0.09993667548238118 +2.652 0.7069954650645828 0.7069942616057845 1.0627825865021368e-08 -0.09993669471310207 +2.6521000000000003 0.7069954996416575 0.7069942950096914 1.1392253467835955e-08 -0.09993671393798476 +2.6522 0.7069955342164636 0.7069943283952254 1.2143879916416689e-08 -0.09993673315703094 +2.6523000000000003 0.7069955687888639 0.7069943617625293 1.2882535703126474e-08 -0.0999367523702424 +2.6524 0.706995603358721 0.7069943951117479 1.360805436043111e-08 -0.09993677157762096 +2.6525 0.7069956379258945 0.706994428443027 1.4320272499063202e-08 -0.09993679077916834 +2.6526000000000005 0.7069956724902428 0.706994461756515 1.5019029848788168e-08 -0.09993680997488637 +2.6527000000000003 0.7069957070516224 0.7069944950523614 1.5704169298302872e-08 -0.09993682916477677 +2.6528 0.7069957416098882 0.7069945283307175 1.6375536921256484e-08 -0.09993684834884133 +2.6529000000000003 0.7069957761648936 0.7069945615917365 1.7032982018751197e-08 -0.0999368675270818 +2.653 0.7069958107164904 0.7069945948355725 1.7676357146230448e-08 -0.09993688669949996 +2.6531000000000002 0.7069958452645284 0.7069946280623818 1.830551814643866e-08 -0.09993690586609756 +2.6532000000000004 0.7069958798088569 0.706994661272322 1.8920324187585158e-08 -0.0999369250268764 +2.6533 0.7069959143493226 0.706994694465552 1.9520637793701834e-08 -0.09993694418183822 +2.6534 0.7069959488857717 0.7069947276422321 2.010632487326608e-08 -0.09993696333098478 +2.6535 0.7069959834180484 0.7069947608025247 2.067725474955845e-08 -0.09993698247431788 +2.6536000000000004 0.7069960179459955 0.7069947939465921 2.1233300191887683e-08 -0.09993700161183922 +2.6537 0.7069960524694552 0.7069948270745997 2.1774337435540025e-08 -0.0999370207435506 +2.6538000000000004 0.7069960869882674 0.7069948601867131 2.230024621907578e-08 -0.09993703986945379 +2.6539 0.7069961215022715 0.7069948932830992 2.2810909808615443e-08 -0.09993705898955055 +2.654 0.7069961560113054 0.7069949263639262 2.330621501692165e-08 -0.09993707810384261 +2.6541000000000006 0.7069961905152058 0.7069949594293639 2.378605224936936e-08 -0.09993709721233177 +2.6542000000000003 0.7069962250138087 0.7069949924795824 2.4250315500476405e-08 -0.09993711631501977 +2.6543 0.7069962595069484 0.7069950255147539 2.4698902385128507e-08 -0.09993713541190836 +2.6544 0.7069962939944585 0.7069950585350508 2.5131714176743203e-08 -0.09993715450299934 +2.6545 0.7069963284761713 0.7069950915406471 2.5548655810739285e-08 -0.09993717358829447 +2.6546000000000003 0.7069963629519185 0.7069951245317172 2.5949635914027103e-08 -0.09993719266779544 +2.6547 0.7069963974215303 0.7069951575084368 2.6334566829294692e-08 -0.09993721174150406 +2.6548000000000003 0.706996431884837 0.7069951904709827 2.6703364616742498e-08 -0.0999372308094221 +2.6549 0.7069964663416668 0.706995223419532 2.7055949095716736e-08 -0.09993724987155127 +2.655 0.7069965007918481 0.7069952563542632 2.7392243844709396e-08 -0.09993726892789334 +2.6551000000000005 0.7069965352352079 0.7069952892753553 2.77121762204402e-08 -0.09993728797845014 +2.6552000000000002 0.7069965696715729 0.7069953221829877 2.801567737520383e-08 -0.09993730702322334 +2.6553 0.7069966041007689 0.7069953550773412 2.830268227768662e-08 -0.09993732606221478 +2.6554 0.7069966385226207 0.7069953879585964 2.857312972857906e-08 -0.09993734509542605 +2.6555 0.7069966729369532 0.7069954208269351 2.8826962355371633e-08 -0.09993736412285906 +2.6556 0.7069967073435901 0.7069954536825398 2.9064126629702036e-08 -0.0999373831445155 +2.6557000000000004 0.706996741742355 0.706995486525593 2.928457290898856e-08 -0.09993740216039709 +2.6558 0.706996776133071 0.7069955193562782 2.948825539826616e-08 -0.09993742117050569 +2.6559 0.7069968105155603 0.7069955521747788 2.9675132197024e-08 -0.09993744017484296 +2.656 0.7069968448896451 0.7069955849812792 2.9845165288797104e-08 -0.0999374591734107 +2.6561000000000003 0.7069968792551473 0.7069956177759635 2.9998320555044145e-08 -0.09993747816621061 +2.6562 0.706996913611888 0.7069956505590167 3.0134567783821065e-08 -0.09993749715324446 +2.6563000000000003 0.7069969479596887 0.7069956833306238 3.025388067325052e-08 -0.09993751613451403 +2.6564 0.7069969822983704 0.70699571609097 3.035623682631772e-08 -0.09993753511002104 +2.6565 0.7069970166277534 0.706995748840241 3.044161777689125e-08 -0.09993755407976729 +2.6566000000000005 0.7069970509476585 0.7069957815786221 3.0510008975845326e-08 -0.09993757304375445 +2.6567000000000003 0.7069970852579059 0.7069958143062991 3.056139979452921e-08 -0.09993759200198427 +2.6568 0.7069971195583165 0.7069958470234579 3.059578353517556e-08 -0.09993761095445854 +2.6569000000000003 0.7069971538487103 0.706995879730284 3.0613157423961534e-08 -0.09993762990117899 +2.657 0.7069971881289077 0.7069959124269635 3.061352260927408e-08 -0.09993764884214731 +2.6571000000000002 0.7069972223987293 0.706995945113682 3.0596884161709914e-08 -0.09993766777736537 +2.6572000000000005 0.7069972566579955 0.7069959777906254 3.056325107407554e-08 -0.09993768670683484 +2.6573 0.7069972909065271 0.7069960104579789 3.05126362665914e-08 -0.09993770563055746 +2.6574 0.706997325144145 0.7069960431159277 3.044505655393215e-08 -0.099937724548535 +2.6575 0.7069973593706704 0.706996075764657 3.036053268339056e-08 -0.09993774346076917 +2.6576000000000004 0.7069973935859246 0.7069961084043515 3.025908928283583e-08 -0.09993776236726176 +2.6577 0.7069974277897291 0.7069961410351958 3.01407548867344e-08 -0.09993778126801445 +2.6578000000000004 0.7069974619819062 0.706996173657374 3.0005561911863876e-08 -0.09993780016302906 +2.6579 0.7069974961622782 0.70699620627107 2.985354666078244e-08 -0.0999378190523073 +2.658 0.7069975303306681 0.7069962388764663 2.9684749304481617e-08 -0.09993783793585084 +2.6581000000000006 0.7069975644868992 0.7069962714737466 2.949921386850851e-08 -0.09993785681366149 +2.6582000000000003 0.7069975986307955 0.7069963040630924 2.929698823296578e-08 -0.09993787568574099 +2.6583 0.7069976327621811 0.7069963366446861 2.9078124113429693e-08 -0.09993789455209103 +2.6584 0.7069976668808814 0.7069963692187087 2.8842677034929265e-08 -0.09993791341271345 +2.6585 0.7069977009867219 0.7069964017853405 2.8590706345824057e-08 -0.09993793226760989 +2.6586000000000003 0.7069977350795291 0.706996434344761 2.832227518657915e-08 -0.09993795111678214 +2.6587 0.70699776915913 0.7069964668971496 2.8037450468948455e-08 -0.0999379699602319 +2.6588000000000003 0.7069978032253523 0.7069964994426844 2.7736302870770557e-08 -0.09993798879796087 +2.6589 0.7069978372780248 0.706996531981543 2.7418906822090916e-08 -0.09993800762997085 +2.659 0.7069978713169772 0.706996564513902 2.708534046005906e-08 -0.09993802645626361 +2.6591000000000005 0.7069979053420397 0.7069965970399374 2.6735685637602202e-08 -0.09993804527684083 +2.6592000000000002 0.7069979393530436 0.7069966295598238 2.6370027900873838e-08 -0.09993806409170425 +2.6593 0.7069979733498211 0.7069966620737347 2.598845645282455e-08 -0.09993808290085557 +2.6594 0.7069980073322056 0.7069966945818436 2.5591064149732556e-08 -0.09993810170429661 +2.6595 0.7069980413000314 0.7069967270843218 2.5177947461305084e-08 -0.09993812050202898 +2.6596 0.706998075253134 0.7069967595813401 2.4749206455065842e-08 -0.09993813929405448 +2.6597000000000004 0.70699810919135 0.7069967920730685 2.4304944779007798e-08 -0.09993815808037493 +2.6598 0.7069981431145167 0.7069968245596752 2.3845269618225085e-08 -0.09993817686099193 +2.6599 0.7069981770224733 0.7069968570413272 2.337029169838245e-08 -0.09993819563590725 +2.66 0.7069982109150599 0.7069968895181908 2.2880125230204107e-08 -0.09993821440512263 +2.6601000000000004 0.7069982447921175 0.7069969219904306 2.2374887897330664e-08 -0.09993823316863977 +2.6602 0.7069982786534892 0.7069969544582101 2.185470082596147e-08 -0.09993825192646044 +2.6603000000000003 0.7069983124990189 0.7069969869216914 2.1319688546690696e-08 -0.09993827067858635 +2.6604 0.706998346328552 0.7069970193810353 2.076997897282329e-08 -0.09993828942501926 +2.6605 0.7069983801419353 0.706997051836401 2.0205703382160378e-08 -0.09993830816576083 +2.6606000000000005 0.7069984139390169 0.7069970842879465 1.962699636409021e-08 -0.09993832690081285 +2.6607000000000003 0.7069984477196467 0.706997116735828 1.903399579703674e-08 -0.099938345630177 +2.6608 0.7069984814836761 0.7069971491802001 1.842684281636725e-08 -0.099938364353855 +2.6609000000000003 0.7069985152309577 0.7069971816212163 1.7805681777963156e-08 -0.0999383830718486 +2.661 0.706998548961346 0.7069972140590284 1.7170660217454004e-08 -0.09993840178415954 +2.6611000000000002 0.706998582674697 0.7069972464937866 1.6521928840676492e-08 -0.09993842049078955 +2.6612000000000005 0.7069986163708686 0.7069972789256389 1.5859641458622342e-08 -0.09993843919174034 +2.6613 0.7069986500497201 0.7069973113547323 1.5183954966621616e-08 -0.09993845788701362 +2.6614 0.7069986837111124 0.7069973437812116 1.4495029303576712e-08 -0.09993847657661112 +2.6615 0.7069987173549085 0.7069973762052202 1.379302741206373e-08 -0.09993849526053454 +2.6616000000000004 0.706998750980973 0.7069974086268991 1.3078115202770635e-08 -0.09993851393878557 +2.6617 0.7069987845891725 0.7069974410463884 1.2350461513731259e-08 -0.09993853261136605 +2.6618000000000004 0.7069988181793753 0.7069974734638259 1.161023807563083e-08 -0.09993855127827764 +2.6619 0.7069988517514515 0.7069975058793472 1.0857619459764267e-08 -0.09993856993952205 +2.662 0.7069988853052733 0.7069975382930866 1.009278304681116e-08 -0.099938588595101 +2.6621000000000006 0.7069989188407144 0.7069975707051759 9.31590898346768e-09 -0.0999386072450162 +2.6622000000000003 0.7069989523576514 0.7069976031157452 8.527180140813218e-09 -0.0999386258892694 +2.6623 0.706998985855962 0.7069976355249226 7.726782064870763e-09 -0.09993864452786233 +2.6624 0.7069990193355261 0.7069976679328343 6.914902937575629e-09 -0.09993866316079664 +2.6625 0.706999052796226 0.7069977003396039 6.091733536009447e-09 -0.0999386817880741 +2.6626000000000003 0.7069990862379456 0.7069977327453534 5.257467181225828e-09 -0.09993870040969637 +2.6627 0.7069991196605715 0.706997765150203 4.412299698351718e-09 -0.09993871902566522 +2.6628000000000003 0.7069991530639919 0.7069977975542698 3.5564293654130608e-09 -0.09993873763598232 +2.6629 0.7069991864480971 0.7069978299576696 2.690056867364621e-09 -0.0999387562406494 +2.663 0.7069992198127805 0.706997862360516 1.8133852535892614e-09 -0.09993877483966826 +2.6631000000000005 0.7069992531579364 0.7069978947629197 9.266198875909626e-10 -0.09993879343304049 +2.6632000000000002 0.7069992864834627 0.7069979271649898 2.9968402759372736e-11 -0.0999388120207679 +2.6633 0.7069993197892582 0.7069979595668328 -8.763593531413427e-10 -0.09993883060285215 +2.6634 0.7069993530752249 0.706997991968553 -1.7921513630753116e-09 -0.09993884917929494 +2.6635 0.7069993863412667 0.7069980243702525 -2.7171934962461064e-09 -0.099938867750098 +2.6636 0.7069994195872901 0.7069980567720306 -3.6512695419238517e-09 -0.09993888631526301 +2.6637000000000004 0.7069994528132038 0.7069980891739855 -4.594161284038334e-09 -0.09993890487479176 +2.6638 0.7069994860189186 0.7069981215762118 -5.545648528934577e-09 -0.09993892342868593 +2.6639 0.7069995192043483 0.7069981539788017 -6.505509168690249e-09 -0.0999389419769472 +2.664 0.7069995523694088 0.706998186381846 -7.473519230555281e-09 -0.0999389605195773 +2.6641000000000004 0.7069995855140181 0.7069982187854319 -8.449452935065105e-09 -0.09993897905657793 +2.6642 0.7069996186380971 0.7069982511896449 -9.433082736806653e-09 -0.09993899758795077 +2.6643000000000003 0.706999651741569 0.706998283594568 -1.0424179391205213e-08 -0.0999390161136976 +2.6644 0.7069996848243595 0.7069983160002815 -1.1422511992688344e-08 -0.09993903463382009 +2.6645 0.7069997178863967 0.7069983484068633 -1.2427848038003286e-08 -0.09993905314831997 +2.6646000000000005 0.7069997509276114 0.7069983808143885 -1.343995348389651e-08 -0.09993907165719887 +2.6647000000000003 0.7069997839479367 0.7069984132229299 -1.4458592791349173e-08 -0.09993909016045854 +2.6648 0.7069998169473083 0.706998445632558 -1.5483528986726114e-08 -0.09993910865810068 +2.6649000000000003 0.7069998499256647 0.7069984780433402 -1.6514523715985968e-08 -0.09993912715012698 +2.665 0.7069998828829468 0.7069985104553419 -1.7551337301493358e-08 -0.09993914563653919 +2.6651000000000002 0.7069999158190983 0.7069985428686255 -1.8593728793193237e-08 -0.09993916411733901 +2.6652000000000005 0.7069999487340648 0.7069985752832509 -1.964145603019357e-08 -0.09993918259252807 +2.6653000000000002 0.7069999816277954 0.7069986076992756 -2.069427569020496e-08 -0.09993920106210817 +2.6654 0.7070000145002413 0.7069986401167541 -2.1751943351990682e-08 -0.09993921952608095 +2.6655 0.7070000473513567 0.7069986725357383 -2.28142135495768e-08 -0.09993923798444815 +2.6656000000000004 0.7070000801810981 0.7069987049562778 -2.388083982993172e-08 -0.09993925643721141 +2.6657 0.7070001129894248 0.7069987373784195 -2.495157481151311e-08 -0.09993927488437254 +2.6658000000000004 0.7070001457762989 0.7069987698022069 -2.602617023761064e-08 -0.09993929332593314 +2.6659 0.7070001785416846 0.7069988022276817 -2.710437703619395e-08 -0.09993931176189491 +2.666 0.7070002112855497 0.7069988346548828 -2.8185945377375357e-08 -0.09993933019225962 +2.6661000000000006 0.7070002440078638 0.7069988670838456 -2.9270624734992548e-08 -0.09993934861702886 +2.6662000000000003 0.7070002767085997 0.7069988995146039 -3.035816393626503e-08 -0.09993936703620439 +2.6663 0.7070003093877331 0.7069989319471883 -3.1448311229448356e-08 -0.09993938544978796 +2.6664 0.7070003420452418 0.7069989643816266 -3.254081433392425e-08 -0.09993940385778118 +2.6665 0.7070003746811069 0.706998996817944 -3.363542050221699e-08 -0.09993942226018585 +2.6666000000000003 0.7070004072953118 0.7069990292561625 -3.473187658049187e-08 -0.09993944065700353 +2.6667 0.7070004398878429 0.7069990616963022 -3.582992906374111e-08 -0.09993945904823599 +2.6668000000000003 0.7070004724586889 0.7069990941383801 -3.692932415628233e-08 -0.09993947743388491 +2.6669 0.7070005050078418 0.7069991265824106 -3.802980782857072e-08 -0.099939495813952 +2.667 0.707000537535296 0.7069991590284049 -3.913112587758914e-08 -0.09993951418843895 +2.6671000000000005 0.7070005700410487 0.706999191476372 -4.0233023983606096e-08 -0.09993953255734743 +2.6672000000000002 0.7070006025250999 0.7069992239263178 -4.133524777213786e-08 -0.09993955092067915 +2.6673 0.7070006349874522 0.7069992563782459 -4.2437542869649394e-08 -0.09993956927843585 +2.6674 0.7070006674281109 0.7069992888321566 -4.3539654963354864e-08 -0.09993958763061914 +2.6675 0.7070006998470844 0.7069993212880479 -4.4641329859920406e-08 -0.09993960597723074 +2.6676 0.707000732244383 0.7069993537459148 -4.5742313544349864e-08 -0.09993962431827232 +2.6677000000000004 0.7070007646200208 0.7069993862057501 -4.684235223648527e-08 -0.09993964265374565 +2.6678 0.707000796974014 0.7069994186675431 -4.794119245251499e-08 -0.09993966098365237 +2.6679 0.7070008293063815 0.7069994511312808 -4.903858106261941e-08 -0.09993967930799413 +2.668 0.707000861617145 0.7069994835969478 -5.013426534810836e-08 -0.0999396976267727 +2.6681000000000004 0.7070008939063289 0.706999516064525 -5.122799305720335e-08 -0.09993971593998967 +2.6682 0.7070009261739605 0.7069995485339919 -5.2319512471119684e-08 -0.09993973424764681 +2.6683000000000003 0.7070009584200694 0.7069995810053245 -5.340857245307237e-08 -0.09993975254974574 +2.6684 0.7070009906446881 0.7069996134784959 -5.449492251050937e-08 -0.09993977084628823 +2.6685 0.7070010228478523 0.7069996459534773 -5.557831285235744e-08 -0.09993978913727593 +2.6686000000000005 0.7070010550295991 0.7069996784302366 -5.6658494446918534e-08 -0.09993980742271047 +2.6687000000000003 0.7070010871899697 0.706999710908739 -5.7735219076513605e-08 -0.0999398257025936 +2.6688 0.7070011193290067 0.7069997433889476 -5.880823939798108e-08 -0.09993984397692696 +2.6689000000000003 0.7070011514467562 0.7069997758708224 -5.987730899601959e-08 -0.09993986224571226 +2.669 0.707001183543267 0.706999808354321 -6.09421824410844e-08 -0.0999398805089512 +2.6691000000000003 0.7070012156185899 0.706999840839398 -6.200261534880167e-08 -0.09993989876664543 +2.6692000000000005 0.7070012476727785 0.706999873326006 -6.305836443070909e-08 -0.09993991701879668 +2.6693000000000002 0.7070012797058893 0.7069999058140943 -6.410918755453757e-08 -0.09993993526540657 +2.6694 0.7070013117179808 0.7069999383036103 -6.51548437966866e-08 -0.09993995350647679 +2.6695 0.7070013437091149 0.7069999707944983 -6.619509349816907e-08 -0.09993997174200905 +2.6696000000000004 0.7070013756793553 0.7070000032867001 -6.722969832185718e-08 -0.099939989972005 +2.6697 0.7070014076287687 0.7070000357801554 -6.825842130105467e-08 -0.09994000819646637 +2.6698000000000004 0.7070014395574244 0.7070000682748008 -6.928102690151317e-08 -0.09994002641539479 +2.6699 0.7070014714653936 0.707000100770571 -7.029728107173921e-08 -0.099940044628792 +2.67 0.7070015033527507 0.7070001332673975 -7.130695129590331e-08 -0.09994006283665963 +2.6701000000000006 0.7070015352195719 0.7070001657652096 -7.230980664501424e-08 -0.0999400810389993 +2.6702000000000004 0.7070015670659364 0.7070001982639347 -7.33056178358997e-08 -0.0999400992358128 +2.6703 0.7070015988919256 0.7070002307634966 -7.429415727630909e-08 -0.09994011742710168 +2.6704 0.7070016306976237 0.7070002632638183 -7.527519912259306e-08 -0.09994013561286783 +2.6705 0.7070016624831168 0.7070002957648187 -7.624851933001053e-08 -0.09994015379311276 +2.6706000000000003 0.7070016942484931 0.7070003282664152 -7.721389570173459e-08 -0.09994017196783811 +2.6707 0.7070017259938444 0.7070003607685228 -7.817110794089421e-08 -0.09994019013704568 +2.6708000000000003 0.7070017577192635 0.7070003932710537 -7.911993770131492e-08 -0.09994020830073702 +2.6709 0.7070017894248464 0.7070004257739186 -8.00601686395605e-08 -0.09994022645891391 +2.671 0.707001821110691 0.7070004582770253 -8.099158645483162e-08 -0.09994024461157797 +2.6711000000000005 0.7070018527768975 0.7070004907802793 -8.191397895054853e-08 -0.09994026275873089 +2.6712000000000002 0.7070018844235686 0.7070005232835841 -8.282713607338232e-08 -0.09994028090037435 +2.6713 0.7070019160508089 0.7070005557868408 -8.373084996356195e-08 -0.09994029903650997 +2.6714 0.7070019476587251 0.7070005882899485 -8.46249150086506e-08 -0.09994031716713947 +2.6715 0.7070019792474267 0.7070006207928038 -8.550912787563814e-08 -0.09994033529226448 +2.6716 0.7070020108170247 0.7070006532953015 -8.638328757165636e-08 -0.09994035341188671 +2.6717000000000004 0.707002042367633 0.7070006857973341 -8.724719548301035e-08 -0.09994037152600785 +2.6718 0.7070020738993666 0.7070007182987919 -8.810065542028123e-08 -0.0999403896346295 +2.6719 0.7070021054123434 0.7070007507995633 -8.894347366429634e-08 -0.09994040773775342 +2.672 0.707002136906683 0.7070007832995342 -8.977545901556888e-08 -0.09994042583538117 +2.6721000000000004 0.7070021683825068 0.7070008157985894 -9.059642282378821e-08 -0.09994044392751451 +2.6722 0.7070021998399387 0.707000848296611 -9.140617903465736e-08 -0.09994046201415509 +2.6723000000000003 0.7070022312791042 0.707000880793479 -9.220454424800628e-08 -0.09994048009530448 +2.6724 0.7070022627001308 0.707000913289072 -9.299133773860851e-08 -0.09994049817096445 +2.6725 0.7070022941031481 0.7070009457832664 -9.376638150735556e-08 -0.09994051624113666 +2.6726000000000005 0.7070023254882873 0.7070009782759368 -9.452950032115548e-08 -0.09994053430582275 +2.6727000000000003 0.7070023568556818 0.7070010107669555 -9.52805217502295e-08 -0.09994055236502439 +2.6728 0.7070023882054666 0.707001043256194 -9.601927620714323e-08 -0.09994057041874324 +2.6729000000000003 0.7070024195377782 0.707001075743521 -9.674559698497065e-08 -0.09994058846698096 +2.673 0.707002450852755 0.7070011082288039 -9.745932030066212e-08 -0.09994060650973921 +2.6731000000000003 0.7070024821505381 0.7070011407119084 -9.816028532193266e-08 -0.09994062454701969 +2.6732000000000005 0.7070025134312685 0.7070011731926986 -9.884833421063e-08 -0.09994064257882404 +2.6733000000000002 0.7070025446950903 0.7070012056710365 -9.952331215222487e-08 -0.09994066060515389 +2.6734 0.7070025759421485 0.7070012381467828 -1.0018506740004651e-07 -0.09994067862601093 +2.6735 0.7070026071725902 0.7070012706197966 -1.0083345130390553e-07 -0.0999406966413968 +2.6736000000000004 0.7070026383865635 0.7070013030899354 -1.0146831834131897e-07 -0.0999407146513132 +2.6737 0.7070026695842184 0.7070013355570548 -1.0208952614786798e-07 -0.09994073265576171 +2.6738000000000004 0.7070027007657063 0.70700136802101 -1.0269693555536169e-07 -0.09994075065474409 +2.6739 0.7070027319311801 0.7070014004816536 -1.032904106291338e-07 -0.09994076864826196 +2.674 0.7070027630807939 0.7070014329388372 -1.03869818681053e-07 -0.09994078663631695 +2.6741 0.7070027942147035 0.7070014653924112 -1.0443503031115631e-07 -0.09994080461891072 +2.6742000000000004 0.7070028253330656 0.7070014978422241 -1.0498591943887414e-07 -0.09994082259604495 +2.6743 0.7070028564360389 0.7070015302881241 -1.0552236331864279e-07 -0.09994084056772133 +2.6744 0.7070028875237828 0.7070015627299568 -1.060442425763336e-07 -0.09994085853394143 +2.6745 0.7070029185964581 0.7070015951675679 -1.0655144123440652e-07 -0.09994087649470701 +2.6746000000000003 0.7070029496542272 0.7070016276008007 -1.0704384673793088e-07 -0.09994089445001966 +2.6747 0.7070029806972526 0.7070016600294979 -1.0752134998147367e-07 -0.09994091239988105 +2.6748000000000003 0.7070030117256989 0.7070016924535016 -1.0798384532818145e-07 -0.09994093034429283 +2.6749 0.7070030427397316 0.7070017248726513 -1.084312306297297e-07 -0.0999409482832566 +2.675 0.7070030737395171 0.7070017572867872 -1.0886340726448673e-07 -0.09994096621677406 +2.6751000000000005 0.7070031047252228 0.7070017896957472 -1.0928028014618729e-07 -0.0999409841448469 +2.6752000000000002 0.7070031356970173 0.7070018220993692 -1.09681757736943e-07 -0.09994100206747675 +2.6753 0.70700316665507 0.7070018544974892 -1.1006775209494724e-07 -0.09994101998466526 +2.6754000000000002 0.707003197599551 0.707001886889943 -1.1043817886580154e-07 -0.09994103789641405 +2.6755 0.7070032285306316 0.7070019192765651 -1.1079295732067951e-07 -0.0999410558027248 +2.6756 0.7070032594484836 0.7070019516571894 -1.1113201036153098e-07 -0.09994107370359914 +2.6757000000000004 0.7070032903532797 0.707001984031649 -1.1145526452975563e-07 -0.09994109159903869 +2.6758 0.7070033212451938 0.7070020163997768 -1.1176265005304054e-07 -0.09994110948904522 +2.6759 0.7070033521243997 0.7070020487614035 -1.120541008332171e-07 -0.09994112737362028 +2.676 0.7070033829910726 0.7070020811163608 -1.1232955446013881e-07 -0.09994114525276555 +2.6761000000000004 0.7070034138453873 0.7070021134644784 -1.1258895224464105e-07 -0.0999411631264826 +2.6762 0.7070034446875206 0.7070021458055867 -1.1283223921333685e-07 -0.0999411809947732 +2.6763000000000003 0.7070034755176489 0.7070021781395145 -1.1305936413290307e-07 -0.0999411988576389 +2.6764 0.7070035063359492 0.7070022104660907 -1.1327027950834567e-07 -0.0999412167150814 +2.6765 0.7070035371425991 0.7070022427851436 -1.1346494158993858e-07 -0.09994123456710234 +2.6766000000000005 0.7070035679377766 0.7070022750965009 -1.1364331040444875e-07 -0.09994125241370336 +2.6767000000000003 0.7070035987216603 0.70700230739999 -1.1380534974993195e-07 -0.0999412702548861 +2.6768 0.7070036294944282 0.707002339695438 -1.1395102719052863e-07 -0.09994128809065214 +2.6769000000000003 0.7070036602562602 0.7070023719826718 -1.140803140859542e-07 -0.09994130592100321 +2.677 0.7070036910073348 0.707002404261518 -1.1419318558456015e-07 -0.09994132374594095 +2.6771000000000003 0.7070037217478323 0.7070024365318027 -1.1428962062333403e-07 -0.099941341565467 +2.6772000000000005 0.707003752477932 0.7070024687933523 -1.1436960193136891e-07 -0.09994135937958297 +2.6773000000000002 0.7070037831978135 0.7070025010459926 -1.1443311605761897e-07 -0.09994137718829053 +2.6774 0.7070038139076572 0.7070025332895495 -1.1448015334661332e-07 -0.09994139499159131 +2.6775 0.7070038446076425 0.7070025655238488 -1.1451070794192553e-07 -0.09994141278948693 +2.6776000000000004 0.7070038752979495 0.7070025977487165 -1.1452477779484715e-07 -0.09994143058197905 +2.6777 0.7070039059787584 0.7070026299639784 -1.1452236465397947e-07 -0.09994144836906929 +2.6778000000000004 0.7070039366502489 0.7070026621694604 -1.1450347408084594e-07 -0.09994146615075933 +2.6779 0.7070039673126008 0.7070026943649887 -1.1446811542907553e-07 -0.09994148392705081 +2.678 0.7070039979659939 0.7070027265503891 -1.1441630184613749e-07 -0.09994150169794533 +2.6781 0.7070040286106074 0.7070027587254883 -1.1434805028374961e-07 -0.09994151946344455 +2.6782000000000004 0.7070040592466207 0.7070027908901124 -1.1426338147185744e-07 -0.09994153722355008 +2.6783 0.7070040898742127 0.7070028230440886 -1.1416231992036896e-07 -0.09994155497826357 +2.6784 0.7070041204935618 0.707002855187244 -1.1404489391221573e-07 -0.09994157272758665 +2.6785 0.7070041511048465 0.7070028873194061 -1.1391113551029175e-07 -0.09994159047152094 +2.6786000000000003 0.7070041817082447 0.7070029194404028 -1.1376108051582012e-07 -0.09994160821006814 +2.6787 0.7070042123039337 0.7070029515500624 -1.1359476849437389e-07 -0.09994162594322983 +2.6788000000000003 0.7070042428920907 0.7070029836482139 -1.1341224274118156e-07 -0.09994164367100769 +2.6789 0.7070042734728919 0.7070030157346865 -1.1321355028633129e-07 -0.0999416613934033 +2.679 0.7070043040465135 0.7070030478093099 -1.129987418670153e-07 -0.0999416791104183 +2.6791000000000005 0.7070043346131305 0.7070030798719146 -1.1276787192579518e-07 -0.09994169682205434 +2.6792000000000002 0.7070043651729176 0.7070031119223319 -1.1252099860019349e-07 -0.09994171452831303 +2.6793 0.7070043957260492 0.7070031439603934 -1.1225818369146878e-07 -0.09994173222919608 +2.6794000000000002 0.7070044262726983 0.7070031759859317 -1.1197949266635032e-07 -0.09994174992470503 +2.6795 0.7070044568130378 0.7070032079987798 -1.1168499463101722e-07 -0.09994176761484161 +2.6796 0.7070044873472391 0.7070032399987716 -1.1137476232415955e-07 -0.0999417852996073 +2.6797000000000004 0.7070045178754732 0.7070032719857422 -1.1104887208575331e-07 -0.09994180297900385 +2.6798 0.7070045483979104 0.7070033039595272 -1.1070740384144795e-07 -0.09994182065303285 +2.6799 0.7070045789147195 0.707003335919963 -1.1035044110083159e-07 -0.09994183832169591 +2.68 0.7070046094260691 0.7070033678668874 -1.0997807090191991e-07 -0.09994185598499469 +2.6801000000000004 0.7070046399321264 0.7070033998001388 -1.0959038382676867e-07 -0.09994187364293083 +2.6802 0.7070046704330575 0.7070034317195568 -1.091874739598403e-07 -0.09994189129550596 +2.6803000000000003 0.7070047009290277 0.7070034636249818 -1.0876943887065671e-07 -0.09994190894272165 +2.6804 0.7070047314202008 0.7070034955162556 -1.083363795860437e-07 -0.09994192658457957 +2.6805 0.7070047619067403 0.7070035273932209 -1.0788840056237536e-07 -0.09994194422108132 +2.6806000000000005 0.7070047923888074 0.7070035592557216 -1.074256096725637e-07 -0.09994196185222853 +2.6807000000000003 0.7070048228665631 0.7070035911036031 -1.0694811817570093e-07 -0.09994197947802287 +2.6808 0.7070048533401667 0.7070036229367116 -1.064560406806303e-07 -0.0999419970984659 +2.6809000000000003 0.707004883809776 0.7070036547548947 -1.0594949513727248e-07 -0.09994201471355926 +2.681 0.7070049142755481 0.7070036865580014 -1.054286027941248e-07 -0.0999420323233046 +2.6811000000000003 0.7070049447376385 0.7070037183458822 -1.0489348816530158e-07 -0.09994204992770356 +2.6812000000000005 0.707004975196201 0.7070037501183886 -1.0434427901578891e-07 -0.09994206752675769 +2.6813000000000002 0.7070050056513881 0.7070037818753736 -1.0378110631720922e-07 -0.09994208512046862 +2.6814 0.7070050361033514 0.7070038136166921 -1.0320410423134141e-07 -0.09994210270883805 +2.6815 0.7070050665522405 0.7070038453421996 -1.0261341005807917e-07 -0.09994212029186753 +2.6816000000000004 0.7070050969982035 0.7070038770517542 -1.0200916422588996e-07 -0.09994213786955874 +2.6817 0.7070051274413869 0.7070039087452146 -1.0139151023977333e-07 -0.09994215544191323 +2.6818 0.7070051578819361 0.7070039404224416 -1.0076059466217896e-07 -0.09994217300893266 +2.6819 0.7070051883199943 0.7070039720832975 -1.0011656705836286e-07 -0.09994219057061864 +2.682 0.7070052187557032 0.7070040037276462 -9.945957998511168e-08 -0.09994220812697278 +2.6821 0.7070052491892035 0.707004035355353 -9.878978893696627e-08 -0.09994222567799674 +2.6822000000000004 0.7070052796206331 0.7070040669662857 -9.810735231152723e-08 -0.09994224322369205 +2.6823 0.707005310050129 0.7070040985603132 -9.741243138343403e-08 -0.09994226076406047 +2.6824 0.7070053404778258 0.707004130137306 -9.670519025579277e-08 -0.09994227829910347 +2.6825 0.7070053709038567 0.707004161697137 -9.598579582114491e-08 -0.09994229582882273 +2.6826000000000003 0.7070054013283531 0.7070041932396803 -9.525441772850751e-08 -0.09994231335321985 +2.6827 0.7070054317514445 0.7070042247648125 -9.451122833653569e-08 -0.09994233087229645 +2.6828000000000003 0.7070054621732584 0.7070042562724115 -9.375640268143026e-08 -0.09994234838605416 +2.6829 0.7070054925939204 0.7070042877623575 -9.299011842142657e-08 -0.09994236589449457 +2.683 0.7070055230135546 0.7070043192345326 -9.221255581771254e-08 -0.09994238339761935 +2.6831000000000005 0.7070055534322819 0.7070043506888206 -9.142389767197862e-08 -0.09994240089543005 +2.6832000000000003 0.7070055838502225 0.7070043821251076 -9.062432928738651e-08 -0.09994241838792828 +2.6833 0.7070056142674943 0.7070044135432816 -8.981403843300734e-08 -0.0999424358751157 +2.6834000000000002 0.7070056446842126 0.7070044449432323 -8.899321528917786e-08 -0.09994245335699385 +2.6835 0.7070056751004914 0.7070044763248524 -8.8162052412806e-08 -0.09994247083356445 +2.6836 0.7070057055164417 0.7070045076880355 -8.732074468446177e-08 -0.09994248830482899 +2.6837000000000004 0.7070057359321733 0.7070045390326786 -8.646948927368281e-08 -0.0999425057707892 +2.6838 0.7070057663477931 0.7070045703586796 -8.560848557652434e-08 -0.09994252323144659 +2.6839 0.7070057967634062 0.7070046016659395 -8.473793517826261e-08 -0.09994254068680282 +2.684 0.7070058271791158 0.7070046329543607 -8.385804180655737e-08 -0.09994255813685948 +2.6841000000000004 0.707005857595022 0.7070046642238486 -8.296901128634904e-08 -0.09994257558161818 +2.6842 0.7070058880112238 0.7070046954743103 -8.207105148521493e-08 -0.09994259302108054 +2.6843000000000004 0.707005918427817 0.7070047267056554 -8.116437226392964e-08 -0.09994261045524815 +2.6844 0.7070059488448956 0.707004757917796 -8.024918544003584e-08 -0.09994262788412267 +2.6845 0.7070059792625512 0.7070047891106457 -7.932570472279216e-08 -0.09994264530770564 +2.6846000000000005 0.7070060096808726 0.7070048202841211 -7.839414566893771e-08 -0.09994266272599865 +2.6847000000000003 0.7070060400999473 0.7070048514381411 -7.745472563932404e-08 -0.09994268013900337 +2.6848 0.7070060705198594 0.7070048825726267 -7.65076637399345e-08 -0.09994269754672132 +2.6849000000000003 0.7070061009406914 0.7070049136875016 -7.555318077244466e-08 -0.0999427149491542 +2.685 0.707006131362523 0.7070049447826915 -7.459149917957847e-08 -0.09994273234630359 +2.6851000000000003 0.7070061617854315 0.7070049758581247 -7.362284300737806e-08 -0.09994274973817108 +2.6852000000000005 0.7070061922094919 0.7070050069137319 -7.264743783277905e-08 -0.0999427671247582 +2.6853000000000002 0.7070062226347767 0.7070050379494464 -7.166551072804866e-08 -0.09994278450606668 +2.6854 0.7070062530613559 0.7070050689652037 -7.067729020007046e-08 -0.09994280188209802 +2.6855 0.707006283489297 0.7070050999609419 -6.968300613439948e-08 -0.09994281925285388 +2.6856000000000004 0.7070063139186653 0.7070051309366016 -6.868288974712367e-08 -0.09994283661833585 +2.6857 0.7070063443495236 0.7070051618921259 -6.767717353368952e-08 -0.09994285397854555 +2.6858 0.7070063747819315 0.7070051928274603 -6.666609120862046e-08 -0.09994287133348455 +2.6859 0.7070064052159466 0.707005223742553 -6.564987765217412e-08 -0.09994288868315443 +2.686 0.7070064356516241 0.7070052546373546 -6.462876885830054e-08 -0.09994290602755683 +2.6861 0.7070064660890165 0.7070052855118183 -6.360300187696274e-08 -0.0999429233666933 +2.6862000000000004 0.7070064965281737 0.7070053163658998 -6.257281476426332e-08 -0.09994294070056549 +2.6863 0.7070065269691428 0.7070053471995575 -6.153844652042814e-08 -0.09994295802917502 +2.6864 0.7070065574119688 0.7070053780127523 -6.050013704123405e-08 -0.09994297535252339 +2.6865 0.7070065878566938 0.7070054088054476 -5.94581270546915e-08 -0.0999429926706123 +2.6866000000000003 0.7070066183033572 0.7070054395776093 -5.8412658072472257e-08 -0.09994300998344322 +2.6867 0.7070066487519963 0.7070054703292066 -5.736397233309723e-08 -0.0999430272910179 +2.6868000000000003 0.707006679202645 0.7070055010602101 -5.631231273840222e-08 -0.09994304459333776 +2.6869 0.7070067096553354 0.7070055317705941 -5.525792280604985e-08 -0.09994306189040453 +2.687 0.7070067401100966 0.7070055624603353 -5.420104660903112e-08 -0.09994307918221979 +2.6871000000000005 0.7070067705669548 0.7070055931294126 -5.3141928719937365e-08 -0.09994309646878508 +2.6872000000000003 0.7070068010259342 0.7070056237778077 -5.208081415263022e-08 -0.09994311375010201 +2.6873 0.7070068314870558 0.7070056544055052 -5.101794831128409e-08 -0.0999431310261722 +2.6874000000000002 0.7070068619503384 0.7070056850124923 -4.995357692674351e-08 -0.09994314829699726 +2.6875 0.7070068924157975 0.7070057155987581 -4.8887946002204585e-08 -0.09994316556257869 +2.6876 0.7070069228834469 0.7070057461642958 -4.782130175867965e-08 -0.09994318282291817 +2.6877000000000004 0.7070069533532968 0.7070057767090997 -4.675389057601665e-08 -0.09994320007801726 +2.6878 0.7070069838253555 0.7070058072331677 -4.5685958934677494e-08 -0.09994321732787753 +2.6879 0.7070070142996282 0.7070058377365003 -4.4617753362286884e-08 -0.09994323457250062 +2.688 0.7070070447761175 0.7070058682191 -4.354952037367594e-08 -0.09994325181188807 +2.6881000000000004 0.7070070752548238 0.7070058986809726 -4.2481506415977514e-08 -0.0999432690460415 +2.6882 0.707007105735744 0.7070059291221262 -4.1413957811410823e-08 -0.09994328627496246 +2.6883000000000004 0.7070071362188732 0.7070059595425718 -4.034712069870064e-08 -0.09994330349865257 +2.6884 0.7070071667042033 0.7070059899423229 -3.928124097930764e-08 -0.09994332071711338 +2.6885 0.707007197191724 0.7070060203213957 -3.821656425909495e-08 -0.09994333793034658 +2.6886000000000005 0.7070072276814218 0.7070060506798088 -3.71533357911534e-08 -0.09994335513835362 +2.6887000000000003 0.707007258173281 0.707006081017584 -3.6091800420371724e-08 -0.09994337234113616 +2.6888 0.7070072886672834 0.707006111334745 -3.503220252624485e-08 -0.0999433895386958 +2.6889000000000003 0.707007319163408 0.7070061416313183 -3.397478596785068e-08 -0.09994340673103408 +2.689 0.7070073496616308 0.7070061719073335 -3.291979402833892e-08 -0.09994342391815263 +2.6891000000000003 0.7070073801619257 0.707006202162822 -3.1867469354757844e-08 -0.09994344110005293 +2.6892000000000005 0.7070074106642641 0.7070062323978188 -3.0818053908072615e-08 -0.09994345827673673 +2.6893000000000002 0.7070074411686144 0.7070062626123605 -2.977178890418465e-08 -0.0999434754482055 +2.6894 0.7070074716749424 0.7070062928064873 -2.8728914757986806e-08 -0.09994349261446088 +2.6895 0.7070075021832114 0.7070063229802406 -2.7689671029370103e-08 -0.09994350977550433 +2.6896000000000004 0.7070075326933825 0.7070063531336659 -2.6654296367278896e-08 -0.09994352693133755 +2.6897 0.7070075632054138 0.7070063832668101 -2.5623028459403896e-08 -0.0999435440819621 +2.6898 0.707007593719261 0.7070064133797231 -2.4596103969515282e-08 -0.09994356122737952 +2.6899 0.7070076242348778 0.7070064434724577 -2.3573758490842006e-08 -0.09994357836759148 +2.69 0.7070076547522145 0.7070064735450681 -2.255622648730804e-08 -0.09994359550259946 +2.6901 0.7070076852712195 0.7070065035976121 -2.1543741239755942e-08 -0.09994361263240512 +2.6902000000000004 0.7070077157918381 0.7070065336301495 -2.053653479867565e-08 -0.09994362975700996 +2.6903 0.7070077463140136 0.7070065636427427 -1.9534837919586018e-08 -0.0999436468764156 +2.6904 0.7070077768376871 0.7070065936354566 -1.8538880023569876e-08 -0.09994366399062361 +2.6905 0.7070078073627967 0.7070066236083583 -1.7548889133089246e-08 -0.09994368109963558 +2.6906000000000003 0.7070078378892783 0.7070066535615176 -1.6565091831219347e-08 -0.09994369820345309 +2.6907 0.7070078684170653 0.7070066834950064 -1.5587713197897507e-08 -0.09994371530207767 +2.6908000000000003 0.7070078989460891 0.7070067134088999 -1.4616976763952988e-08 -0.099943732395511 +2.6909 0.7070079294762779 0.7070067433032741 -1.365310446166737e-08 -0.09994374948375453 +2.691 0.7070079600075583 0.7070067731782088 -1.2696316574033889e-08 -0.09994376656680992 +2.6911000000000005 0.7070079905398539 0.7070068030337853 -1.1746831681848369e-08 -0.09994378364467865 +2.6912000000000003 0.7070080210730867 0.7070068328700877 -1.08048666121012e-08 -0.09994380071736238 +2.6913 0.707008051607176 0.7070068626872024 -9.870636397645016e-09 -0.09994381778486268 +2.6914000000000002 0.7070080821420388 0.7070068924852175 -8.944354215612016e-09 -0.09994383484718111 +2.6915 0.7070081126775899 0.7070069222642243 -8.026231347948998e-09 -0.09994385190431924 +2.6916 0.7070081432137418 0.7070069520243153 -7.1164771246051695e-09 -0.09994386895627862 +2.6917000000000004 0.7070081737504048 0.7070069817655862 -6.215298890138721e-09 -0.09994388600306084 +2.6918 0.7070082042874868 0.7070070114881342 -5.322901944736225e-09 -0.09994390304466744 +2.6919 0.707008234824894 0.7070070411920588 -4.439489493905657e-09 -0.09994392008110004 +2.692 0.7070082653625303 0.707007070877462 -3.565262618986098e-09 -0.09994393711236016 +2.6921000000000004 0.7070082959002972 0.7070071005444478 -2.700420218167132e-09 -0.09994395413844948 +2.6922 0.7070083264380942 0.7070071301931222 -1.8451589587839545e-09 -0.09994397115936948 +2.6923000000000004 0.7070083569758187 0.7070071598235932 -9.99673244357624e-10 -0.09994398817512172 +2.6924 0.7070083875133659 0.707007189435971 -1.6415516342072056e-10 -0.09994400518570777 +2.6925 0.7070084180506295 0.7070072190303677 6.612055590549115e-10 -0.09994402219112923 +2.6926000000000005 0.7070084485875006 0.7070072486068976 1.4762215894137398e-09 -0.09994403919138763 +2.6927000000000003 0.7070084791238684 0.7070072781656768 2.280708046031865e-09 -0.09994405618648453 +2.6928 0.7070085096596208 0.7070073077068236 3.074482527939959e-09 -0.09994407317642157 +2.6929000000000003 0.7070085401946431 0.7070073372304579 3.85736515819135e-09 -0.09994409016120026 +2.693 0.7070085707288187 0.7070073667367021 4.629178635036368e-09 -0.09994410714082219 +2.6931000000000003 0.7070086012620295 0.7070073962256793 5.389748259677918e-09 -0.09994412411528891 +2.6932000000000005 0.707008631794155 0.7070074256975158 6.138901975302757e-09 -0.09994414108460198 +2.6933000000000002 0.7070086623250733 0.7070074551523389 6.876470419123204e-09 -0.09994415804876293 +2.6934 0.7070086928546608 0.7070074845902777 7.602286947530623e-09 -0.09994417500777338 +2.6935 0.7070087233827922 0.7070075140114638 8.316187677728792e-09 -0.09994419196163488 +2.6936000000000004 0.7070087539093399 0.7070075434160292 9.018011532836712e-09 -0.099944208910349 +2.6937 0.7070087844341753 0.707007572804109 9.707600264440008e-09 -0.09994422585391728 +2.6938 0.7070088149571674 0.7070076021758389 1.0384798495959024e-08 -0.09994424279234128 +2.6939 0.7070088454781843 0.7070076315313567 1.1049453754741201e-08 -0.09994425972562258 +2.694 0.7070088759970918 0.7070076608708018 1.1701416511959717e-08 -0.09994427665376265 +2.6941 0.7070089065137548 0.7070076901943154 1.2340540208634343e-08 -0.09994429357676321 +2.6942000000000004 0.7070089370280367 0.7070077195020397 1.2966681298999527e-08 -0.09994431049462577 +2.6943 0.7070089675397986 0.7070077487941189 1.357969926264746e-08 -0.09994432740735187 +2.6944 0.7070089980489006 0.707007778070698 1.4179456660906586e-08 -0.09994434431494303 +2.6945 0.7070090285552014 0.707007807331924 1.4765819155056203e-08 -0.09994436121740083 +2.6946000000000003 0.7070090590585582 0.7070078365779455 1.5338655533214673e-08 -0.09994437811472683 +2.6947 0.7070090895588268 0.7070078658089116 1.589783774329917e-08 -0.09994439500692257 +2.6948000000000003 0.7070091200558619 0.7070078950249739 1.64432409242507e-08 -0.09994441189398967 +2.6949 0.7070091505495166 0.707007924226284 1.6974743432922323e-08 -0.09994442877592959 +2.695 0.707009181039643 0.707007953412996 1.749222686489582e-08 -0.09994444565274398 +2.6951000000000005 0.707009211526092 0.7070079825852644 1.799557609004354e-08 -0.09994446252443435 +2.6952000000000003 0.7070092420087126 0.7070080117432453 1.8484679274212434e-08 -0.09994447939100226 +2.6953 0.7070092724873535 0.7070080408870958 1.8959427905244908e-08 -0.09994449625244924 +2.6954000000000002 0.707009302961862 0.7070080700169741 1.9419716808591336e-08 -0.09994451310877692 +2.6955 0.7070093334320842 0.7070080991330394 1.9865444182004532e-08 -0.09994452995998676 +2.6956 0.707009363897865 0.7070081282354521 2.0296511616356427e-08 -0.09994454680608034 +2.6957000000000004 0.7070093943590491 0.7070081573243739 2.0712824108648498e-08 -0.09994456364705928 +2.6958 0.7070094248154789 0.7070081863999671 2.111429008889998e-08 -0.09994458048292508 +2.6959 0.707009455266997 0.7070082154623951 2.1500821445301355e-08 -0.09994459731367933 +2.696 0.7070094857134442 0.7070082445118218 2.1872333532887978e-08 -0.09994461413932346 +2.6961000000000004 0.7070095161546615 0.7070082735484123 2.222874520042828e-08 -0.09994463095985912 +2.6962 0.7070095465904881 0.7070083025723326 2.2569978806036284e-08 -0.09994464777528783 +2.6963000000000004 0.707009577020763 0.7070083315837495 2.2895960231916757e-08 -0.09994466458561117 +2.6964 0.7070096074453239 0.7070083605828303 2.3206618893906183e-08 -0.09994468139083065 +2.6965 0.7070096378640087 0.7070083895697434 2.3501887767493623e-08 -0.0999446981909479 +2.6966000000000006 0.7070096682766533 0.7070084185446576 2.378170340863739e-08 -0.09994471498596437 +2.6967000000000003 0.7070096986830942 0.707008447507742 2.404600595376505e-08 -0.09994473177588165 +2.6968 0.7070097290831666 0.7070084764591673 2.4294739130181764e-08 -0.09994474856070129 +2.6969000000000003 0.7070097594767053 0.7070085053991035 2.4527850280356422e-08 -0.0999447653404248 +2.697 0.707009789863545 0.707008534327722 2.474529036018691e-08 -0.09994478211505377 +2.6971000000000003 0.7070098202435189 0.7070085632451946 2.494701396502097e-08 -0.09994479888458972 +2.6972000000000005 0.707009850616461 0.7070085921516933 2.5132979312308956e-08 -0.09994481564903426 +2.6973000000000003 0.7070098809822041 0.7070086210473906 2.530314828844138e-08 -0.09994483240838889 +2.6974 0.7070099113405807 0.7070086499324593 2.5457486420993325e-08 -0.09994484916265513 +2.6975 0.7070099416914231 0.7070086788070722 2.5595962909949477e-08 -0.09994486591183452 +2.6976000000000004 0.7070099720345633 0.7070087076714032 2.5718550620765224e-08 -0.09994488265592864 +2.6977 0.7070100023698331 0.7070087365256257 2.582522608436666e-08 -0.09994489939493897 +2.6978 0.7070100326970641 0.707008765369914 2.5915969523171434e-08 -0.09994491612886713 +2.6979 0.7070100630160879 0.7070087942044421 2.599076482853735e-08 -0.09994493285771468 +2.698 0.7070100933267354 0.7070088230293838 2.6049599586783212e-08 -0.09994494958148309 +2.6981 0.7070101236288382 0.7070088518449138 2.6092465065311043e-08 -0.09994496630017397 +2.6982000000000004 0.7070101539222268 0.7070088806512059 2.611935621607553e-08 -0.09994498301378874 +2.6983 0.7070101842067327 0.7070089094484351 2.6130271684257633e-08 -0.09994499972232906 +2.6984 0.7070102144821868 0.707008938236775 2.6125213794386815e-08 -0.09994501642579638 +2.6985 0.7070102447484208 0.7070089670164004 2.6104188555545194e-08 -0.09994503312419228 +2.6986000000000003 0.7070102750052654 0.7070089957874854 2.6067205664837e-08 -0.09994504981751837 +2.6987 0.7070103052525527 0.7070090245502038 2.6014278490041343e-08 -0.09994506650577611 +2.6988000000000003 0.7070103354901143 0.7070090533047293 2.5945424076551094e-08 -0.0999450831889671 +2.6989 0.7070103657177816 0.7070090820512354 2.586066314390345e-08 -0.09994509986709277 +2.699 0.7070103959353873 0.7070091107898953 2.57600200684327e-08 -0.09994511654015471 +2.6991000000000005 0.7070104261427632 0.7070091395208825 2.5643522885004932e-08 -0.09994513320815449 +2.6992000000000003 0.7070104563397427 0.7070091682443693 2.5511203281813888e-08 -0.09994514987109364 +2.6993 0.7070104865261588 0.7070091969605277 2.5363096576094812e-08 -0.09994516652897362 +2.6994000000000002 0.707010516701845 0.70700922566953 2.519924172626753e-08 -0.09994518318179606 +2.6995 0.7070105468666354 0.707009254371547 2.501968131285448e-08 -0.09994519982956243 +2.6996 0.7070105770203651 0.70700928306675 2.4824461522868213e-08 -0.09994521647227433 +2.6997000000000004 0.7070106071628686 0.7070093117553091 2.4613632142872488e-08 -0.0999452331099332 +2.6998 0.7070106372939816 0.707009340437394 2.4387246541635044e-08 -0.09994524974254065 +2.6999 0.7070106674135407 0.7070093691131739 2.4145361670127596e-08 -0.09994526637009815 +2.7 0.7070106975213828 0.7070093977828171 2.3888038023361924e-08 -0.09994528299260728 +2.7001000000000004 0.7070107276173456 0.7070094264464916 2.3615339656002377e-08 -0.09994529961006961 +2.7002 0.7070107577012676 0.7070094551043642 2.332733413899779e-08 -0.0999453162224866 +2.7003000000000004 0.7070107877729878 0.7070094837566014 2.302409255611204e-08 -0.09994533282985985 +2.7004 0.707010817832346 0.7070095124033685 2.2705689486576808e-08 -0.09994534943219083 +2.7005 0.7070108478791833 0.70700954104483 2.237220298774434e-08 -0.09994536602948106 +2.7006000000000006 0.707010877913341 0.7070095696811497 2.202371456386243e-08 -0.09994538262173208 +2.7007000000000003 0.7070109079346623 0.7070095983124904 2.1660309168676506e-08 -0.09994539920894543 +2.7008 0.7070109379429902 0.7070096269390138 2.1282075156857372e-08 -0.09994541579112265 +2.7009000000000003 0.7070109679381699 0.7070096555608809 2.0889104284001203e-08 -0.09994543236826528 +2.701 0.7070109979200465 0.7070096841782517 2.0481491683210784e-08 -0.09994544894037483 +2.7011000000000003 0.7070110278884668 0.7070097127912849 2.0059335824329505e-08 -0.09994546550745287 +2.7012000000000005 0.7070110578432787 0.7070097414001376 1.9622738513074e-08 -0.09994548206950084 +2.7013000000000003 0.7070110877843306 0.7070097700049668 1.9171804853737595e-08 -0.0999454986265203 +2.7014 0.7070111177114731 0.7070097986059278 1.870664322316945e-08 -0.09994551517851281 +2.7015 0.7070111476245571 0.7070098272031746 1.822736524909052e-08 -0.09994553172547983 +2.7016000000000004 0.7070111775234351 0.7070098557968604 1.7734085778868536e-08 -0.09994554826742297 +2.7017 0.7070112074079611 0.7070098843871366 1.722692286303812e-08 -0.0999455648043437 +2.7018 0.7070112372779901 0.7070099129741536 1.670599771280007e-08 -0.09994558133624358 +2.7019 0.7070112671333781 0.7070099415580605 1.6171434677469954e-08 -0.09994559786312408 +2.702 0.7070112969739835 0.7070099701390047 1.562336122105934e-08 -0.09994561438498678 +2.7021 0.7070113267996653 0.7070099987171323 1.506190787890771e-08 -0.09994563090183316 +2.7022000000000004 0.7070113566102838 0.7070100272925883 1.4487208236865778e-08 -0.09994564741366474 +2.7023 0.7070113864057014 0.7070100558655157 1.38993988948663e-08 -0.09994566392048303 +2.7024 0.7070114161857817 0.7070100844360567 1.3298619432229597e-08 -0.09994568042228963 +2.7025 0.7070114459503898 0.7070101130043512 1.2685012387714245e-08 -0.099945696919086 +2.7026000000000003 0.7070114756993924 0.7070101415705381 1.205872321094481e-08 -0.09994571341087367 +2.7027 0.7070115054326578 0.7070101701347544 1.1419900229452107e-08 -0.09994572989765417 +2.7028000000000003 0.7070115351500559 0.7070101986971354 1.0768694626121789e-08 -0.09994574637942903 +2.7029 0.7070115648514583 0.7070102272578149 1.0105260383683201e-08 -0.09994576285619972 +2.703 0.7070115945367381 0.7070102558169253 9.429754272566315e-09 -0.09994577932796776 +2.7031000000000005 0.7070116242057708 0.7070102843745967 8.742335784114874e-09 -0.09994579579473477 +2.7032000000000003 0.7070116538584328 0.7070103129309577 8.043167120178052e-09 -0.09994581225650213 +2.7033 0.7070116834946025 0.7070103414861353 7.332413147140282e-09 -0.09994582871327148 +2.7034000000000002 0.7070117131141604 0.7070103700402544 6.610241349951085e-09 -0.09994584516504422 +2.7035 0.7070117427169887 0.7070103985934384 5.876821794828513e-09 -0.09994586161182195 +2.7036000000000002 0.7070117723029714 0.7070104271458083 5.132327091962596e-09 -0.09994587805360615 +2.7037000000000004 0.7070118018719942 0.707010455697484 4.376932354749341e-09 -0.09994589449039834 +2.7038 0.7070118314239451 0.7070104842485827 3.6108151590247273e-09 -0.09994591092220007 +2.7039 0.7070118609587136 0.7070105127992206 2.8341554996966223e-09 -0.09994592734901281 +2.704 0.7070118904761915 0.7070105413495108 2.0471357508461407e-09 -0.0999459437708381 +2.7041000000000004 0.7070119199762728 0.7070105698995652 1.249940618022749e-09 -0.09994596018767743 +2.7042 0.7070119494588529 0.7070105984494931 4.427571035497957e-10 -0.09994597659953233 +2.7043000000000004 0.7070119789238294 0.7070106269994024 -3.7422554725191626e-10 -0.09994599300640428 +2.7044 0.7070120083711022 0.7070106555493987 -1.2008158859627693e-09 -0.09994600940829482 +2.7045 0.7070120378005735 0.7070106840995853 -2.0368203018303332e-09 -0.09994602580520545 +2.7046000000000006 0.7070120672121469 0.707010712650064 -2.8820430755457926e-09 -0.09994604219713775 +2.7047000000000003 0.7070120966057287 0.7070107412009334 -3.736286418275225e-09 -0.09994605858409311 +2.7048 0.707012125981227 0.7070107697522912 -4.59935052023186e-09 -0.09994607496607316 +2.7049000000000003 0.7070121553385523 0.7070107983042317 -5.471033595778885e-09 -0.0999460913430793 +2.705 0.7070121846776174 0.707010826856848 -6.35113193286907e-09 -0.09994610771511313 +2.7051000000000003 0.7070122139983368 0.7070108554102306 -7.239439941617021e-09 -0.09994612408217608 +2.7052000000000005 0.7070122433006277 0.7070108839644679 -8.13575019853463e-09 -0.09994614044426975 +2.7053000000000003 0.7070122725844096 0.7070109125196455 -9.039853497705419e-09 -0.09994615680139558 +2.7054 0.707012301849604 0.7070109410758476 -9.951538901091517e-09 -0.09994617315355511 +2.7055 0.7070123310961345 0.7070109696331554 -1.0870593781034388e-08 -0.09994618950074982 +2.7056000000000004 0.7070123603239276 0.707010998191648 -1.1796803876633344e-08 -0.09994620584298124 +2.7057 0.7070123895329117 0.7070110267514026 -1.2729953341016759e-08 -0.09994622218025088 +2.7058 0.7070124187230173 0.7070110553124933 -1.3669824792950092e-08 -0.09994623851256018 +2.7059 0.7070124478941779 0.7070110838749923 -1.461619936323974e-08 -0.09994625483991071 +2.706 0.707012477046329 0.7070111124389696 -1.5568856750244192e-08 -0.09994627116230395 +2.7061 0.7070125061794085 0.7070111410044924 -1.652757527278309e-08 -0.09994628747974142 +2.7062000000000004 0.7070125352933567 0.7070111695716259 -1.7492131913939002e-08 -0.09994630379222462 +2.7063 0.7070125643881164 0.7070111981404326 -1.8462302379604334e-08 -0.09994632009975507 +2.7064 0.7070125934636327 0.7070112267109725 -1.9437861147053592e-08 -0.09994633640233419 +2.7065 0.7070126225198532 0.7070112552833037 -2.0418581523490298e-08 -0.09994635269996363 +2.7066000000000003 0.7070126515567278 0.7070112838574809 -2.1404235689415074e-08 -0.09994636899264471 +2.7067 0.7070126805742094 0.7070113124335574 -2.2394594756738884e-08 -0.09994638528037914 +2.7068000000000003 0.7070127095722527 0.707011341011583 -2.3389428823426817e-08 -0.0999464015631682 +2.7069 0.7070127385508151 0.707011369591606 -2.4388507024238754e-08 -0.09994641784101355 +2.707 0.7070127675098569 0.707011398173672 -2.539159758320475e-08 -0.09994643411391668 +2.7071000000000005 0.7070127964493405 0.7070114267578235 -2.639846786913619e-08 -0.09994645038187909 +2.7072000000000003 0.70701282536923 0.7070114553441007 -2.740888445265481e-08 -0.09994646664490214 +2.7073 0.707012854269494 0.7070114839325417 -2.8422613152379733e-08 -0.09994648290298747 +2.7074000000000003 0.7070128831501017 0.7070115125231817 -2.943941909781117e-08 -0.09994649915613656 +2.7075 0.7070129120110261 0.7070115411160536 -3.045906677681849e-08 -0.09994651540435087 +2.7076000000000002 0.7070129408522422 0.7070115697111874 -3.148132009462082e-08 -0.09994653164763194 +2.7077000000000004 0.7070129696737273 0.707011598308611 -3.250594242778029e-08 -0.09994654788598122 +2.7078 0.7070129984754618 0.7070116269083495 -3.3532696676243784e-08 -0.09994656411940023 +2.7079 0.7070130272574283 0.7070116555104256 -3.4561345319721395e-08 -0.09994658034789046 +2.708 0.7070130560196122 0.707011684114859 -3.55916504730892e-08 -0.09994659657145341 +2.7081000000000004 0.7070130847620011 0.7070117127216673 -3.662337394330986e-08 -0.09994661279009055 +2.7082 0.7070131134845854 0.7070117413308656 -3.765627728169116e-08 -0.09994662900380341 +2.7083000000000004 0.7070131421873581 0.7070117699424661 -3.8690121838421375e-08 -0.09994664521259347 +2.7084 0.7070131708703148 0.7070117985564788 -3.972466881900201e-08 -0.09994666141646225 +2.7085 0.7070131995334534 0.7070118271729107 -4.075967934035526e-08 -0.09994667761541122 +2.7086000000000006 0.7070132281767748 0.7070118557917666 -4.1794914484708824e-08 -0.09994669380944192 +2.7087000000000003 0.7070132568002818 0.7070118844130482 -4.283013535307423e-08 -0.0999467099985557 +2.7088 0.7070132854039806 0.7070119130367556 -4.386510312483048e-08 -0.09994672618275423 +2.7089000000000003 0.7070133139878789 0.7070119416628852 -4.4899579108457956e-08 -0.09994674236203885 +2.709 0.7070133425519882 0.7070119702914317 -4.593332479825574e-08 -0.09994675853641116 +2.7091000000000003 0.7070133710963218 0.707011998922387 -4.696610193160103e-08 -0.09994677470587261 +2.7092 0.7070133996208956 0.7070120275557402 -4.799767253939845e-08 -0.09994679087042471 +2.7093000000000003 0.7070134281257281 0.7070120561914781 -4.902779900247886e-08 -0.09994680703006895 +2.7094 0.7070134566108406 0.7070120848295849 -5.005624410803211e-08 -0.09994682318480677 +2.7095 0.7070134850762566 0.707012113470042 -5.10827711042508e-08 -0.09994683933463971 +2.7096000000000005 0.7070135135220021 0.7070121421128288 -5.2107143751721485e-08 -0.09994685547956922 +2.7097 0.7070135419481058 0.7070121707579218 -5.312912637936949e-08 -0.09994687161959678 +2.7098 0.7070135703545993 0.7070121994052947 -5.414848394192165e-08 -0.09994688775472392 +2.7099 0.707013598741516 0.7070122280549194 -5.516498206804485e-08 -0.09994690388495212 +2.71 0.7070136271088925 0.7070122567067649 -5.617838711715825e-08 -0.09994692001028285 +2.7101 0.7070136554567673 0.7070122853607976 -5.718846623494443e-08 -0.09994693613071765 +2.7102000000000004 0.7070136837851817 0.7070123140169813 -5.819498740430688e-08 -0.09994695224625791 +2.7103 0.7070137120941794 0.707012342675278 -5.919771949849592e-08 -0.09994696835690521 +2.7104 0.7070137403838064 0.7070123713356464 -6.01964323353188e-08 -0.09994698446266093 +2.7105 0.7070137686541116 0.7070123999980431 -6.1190896732434e-08 -0.09994700056352664 +2.7106000000000003 0.7070137969051458 0.7070124286624224 -6.218088455071935e-08 -0.09994701665950377 +2.7107 0.7070138251369631 0.7070124573287362 -6.316616875997466e-08 -0.0999470327505939 +2.7108000000000003 0.7070138533496191 0.7070124859969333 -6.414652347882036e-08 -0.09994704883679838 +2.7109 0.707013881543172 0.7070125146669612 -6.512172403497912e-08 -0.09994706491811879 +2.711 0.707013909717683 0.7070125433387637 -6.609154701254713e-08 -0.0999470809945566 +2.7111000000000005 0.7070139378732148 0.7070125720122834 -6.705577030273469e-08 -0.09994709706611322 +2.7112000000000003 0.7070139660098329 0.7070126006874597 -6.80141731567753e-08 -0.09994711313279017 +2.7113 0.7070139941276056 0.7070126293642303 -6.896653623493162e-08 -0.09994712919458897 +2.7114000000000003 0.707014022226603 0.70701265804253 -6.991264166027189e-08 -0.0999471452515111 +2.7115 0.7070140503068976 0.7070126867222916 -7.085227305900221e-08 -0.09994716130355803 +2.7116000000000002 0.7070140783685639 0.7070127154034455 -7.178521562335033e-08 -0.0999471773507312 +2.7117000000000004 0.7070141064116793 0.7070127440859197 -7.271125615276527e-08 -0.09994719339303211 +2.7118 0.7070141344363231 0.7070127727696401 -7.363018310075492e-08 -0.09994720943046224 +2.7119 0.707014162442577 0.7070128014545303 -7.454178662909608e-08 -0.09994722546302305 +2.712 0.7070141904305249 0.7070128301405115 -7.544585865033523e-08 -0.09994724149071604 +2.7121000000000004 0.7070142184002528 0.7070128588275032 -7.634219287809552e-08 -0.09994725751354268 +2.7122 0.707014246351849 0.7070128875154224 -7.723058487434792e-08 -0.0999472735315045 +2.7123000000000004 0.7070142742854041 0.7070129162041833 -7.811083209321307e-08 -0.09994728954460289 +2.7124 0.7070143022010105 0.707012944893699 -7.898273393473765e-08 -0.0999473055528394 +2.7125 0.7070143300987629 0.7070129735838799 -7.984609177655311e-08 -0.09994732155621544 +2.7126000000000006 0.7070143579787582 0.7070130022746344 -8.07007090363257e-08 -0.09994733755473252 +2.7127000000000003 0.7070143858410951 0.7070130309658685 -8.15463912055836e-08 -0.09994735354839206 +2.7128 0.7070144136858749 0.7070130596574868 -8.238294589221762e-08 -0.0999473695371956 +2.7129000000000003 0.7070144415132005 0.7070130883493912 -8.321018287078819e-08 -0.09994738552114456 +2.713 0.7070144693231769 0.7070131170414826 -8.402791412329136e-08 -0.09994740150024051 +2.7131000000000003 0.7070144971159111 0.7070131457336584 -8.483595387905746e-08 -0.09994741747448485 +2.7132 0.7070145248915123 0.707013174425815 -8.563411866332332e-08 -0.09994743344387905 +2.7133000000000003 0.7070145526500913 0.7070132031178469 -8.642222733626359e-08 -0.09994744940842461 +2.7134 0.7070145803917607 0.7070132318096463 -8.720010112681781e-08 -0.09994746536812298 +2.7135 0.7070146081166355 0.7070132605011036 -8.796756368733422e-08 -0.09994748132297564 +2.7136000000000005 0.7070146358248323 0.7070132891921076 -8.87244411195906e-08 -0.09994749727298403 +2.7137000000000002 0.7070146635164694 0.707013317882545 -8.947056201989712e-08 -0.0999475132181497 +2.7138 0.707014691191667 0.7070133465723007 -9.020575751812754e-08 -0.09994752915847405 +2.7139 0.7070147188505477 0.7070133752612578 -9.092986132108738e-08 -0.09994754509395858 +2.714 0.7070147464932346 0.7070134039492978 -9.164270973940208e-08 -0.09994756102460473 +2.7141 0.7070147741198534 0.7070134326363007 -9.234414173695665e-08 -0.099947576950414 +2.7142000000000004 0.7070148017305312 0.7070134613221437 -9.303399895084496e-08 -0.0999475928713878 +2.7143 0.707014829325397 0.7070134900067037 -9.371212574080939e-08 -0.09994760878752765 +2.7144 0.7070148569045813 0.7070135186898552 -9.437836922220055e-08 -0.09994762469883496 +2.7145 0.7070148844682165 0.7070135473714716 -9.503257929373288e-08 -0.0999476406053113 +2.7146000000000003 0.707014912016436 0.7070135760514242 -9.567460867825062e-08 -0.09994765650695812 +2.7147 0.7070149395493748 0.707013604729583 -9.630431295568759e-08 -0.09994767240377685 +2.7148000000000003 0.7070149670671699 0.7070136334058162 -9.692155059342483e-08 -0.09994768829576889 +2.7149 0.7070149945699595 0.707013662079991 -9.752618296884202e-08 -0.09994770418293579 +2.715 0.7070150220578831 0.7070136907519728 -9.811807442309389e-08 -0.09994772006527897 +2.7151000000000005 0.7070150495310821 0.7070137194216257 -9.869709226804912e-08 -0.09994773594279992 +2.7152000000000003 0.7070150769896986 0.7070137480888123 -9.9263106826189e-08 -0.09994775181550003 +2.7153 0.707015104433877 0.7070137767533942 -9.98159914618324e-08 -0.09994776768338093 +2.7154000000000003 0.7070151318637623 0.7070138054152312 -1.0035562260368724e-07 -0.09994778354644396 +2.7155 0.7070151592795008 0.7070138340741821 -1.0088187978388174e-07 -0.0999477994046906 +2.7156000000000002 0.70701518668124 0.707013862730104 -1.0139464564924011e-07 -0.09994781525812228 +2.7157000000000004 0.707015214069129 0.7070138913828538 -1.0189380599510967e-07 -0.09994783110674052 +2.7158 0.7070152414433178 0.7070139200322858 -1.0237924979311641e-07 -0.0999478469505467 +2.7159 0.7070152688039582 0.7070139486782546 -1.02850869210247e-07 -0.09994786278954239 +2.716 0.7070152961512017 0.7070139773206126 -1.0330855963660429e-07 -0.09994787862372893 +2.7161000000000004 0.7070153234852028 0.7070140059592116 -1.0375221970448933e-07 -0.09994789445310792 +2.7162 0.7070153508061152 0.7070140345939024 -1.0418175131962637e-07 -0.09994791027768074 +2.7163000000000004 0.7070153781140948 0.7070140632245346 -1.0459705967590799e-07 -0.09994792609744886 +2.7164 0.7070154054092979 0.7070140918509564 -1.04998053271875e-07 -0.09994794191241368 +2.7165 0.707015432691882 0.707014120473016 -1.0538464394367619e-07 -0.09994795772257675 +2.7166000000000006 0.7070154599620055 0.70701414909056 -1.0575674687113984e-07 -0.09994797352793948 +2.7167000000000003 0.7070154872198278 0.7070141777034344 -1.061142806055293e-07 -0.0999479893285033 +2.7168 0.7070155144655086 0.7070142063114844 -1.0645716708255343e-07 -0.09994800512426973 +2.7169 0.7070155416992088 0.7070142349145543 -1.0678533163711174e-07 -0.09994802091524022 +2.717 0.7070155689210903 0.7070142635124876 -1.0709870303104996e-07 -0.09994803670141619 +2.7171000000000003 0.7070155961313151 0.707014292105127 -1.0739721345489478e-07 -0.09994805248279912 +2.7172 0.7070156233300463 0.7070143206923148 -1.0768079854953788e-07 -0.09994806825939041 +2.7173000000000003 0.7070156505174475 0.7070143492738924 -1.0794939742011372e-07 -0.09994808403119157 +2.7174 0.7070156776936829 0.7070143778497007 -1.0820295264814261e-07 -0.09994809979820402 +2.7175 0.7070157048589176 0.7070144064195798 -1.0844141029933696e-07 -0.09994811556042922 +2.7176000000000005 0.7070157320133169 0.7070144349833698 -1.0866471993574434e-07 -0.09994813131786867 +2.7177000000000002 0.7070157591570466 0.70701446354091 -1.0887283464003361e-07 -0.0999481470705238 +2.7178 0.7070157862902731 0.707014492092039 -1.0906571100768869e-07 -0.09994816281839604 +2.7179 0.7070158134131628 0.7070145206365952 -1.0924330916782521e-07 -0.0999481785614868 +2.718 0.7070158405258832 0.7070145491744164 -1.0940559277798634e-07 -0.09994819429979761 +2.7181 0.7070158676286018 0.7070145777053407 -1.0955252905189838e-07 -0.0999482100333299 +2.7182000000000004 0.7070158947214862 0.7070146062292052 -1.0968408874038882e-07 -0.09994822576208509 +2.7183 0.7070159218047047 0.7070146347458468 -1.0980024615914186e-07 -0.09994824148606465 +2.7184 0.7070159488784256 0.7070146632551024 -1.0990097918002484e-07 -0.09994825720527005 +2.7185 0.707015975942817 0.7070146917568091 -1.0998626924496602e-07 -0.09994827291970271 +2.7186000000000003 0.7070160029980477 0.7070147202508029 -1.1005610136595456e-07 -0.09994828862936408 +2.7187 0.7070160300442865 0.7070147487369205 -1.1011046411636694e-07 -0.09994830433425561 +2.7188000000000003 0.7070160570817021 0.707014777214998 -1.1014934965004886e-07 -0.09994832003437876 +2.7189 0.7070160841104636 0.7070148056848716 -1.1017275368570278e-07 -0.09994833572973498 +2.719 0.7070161111307398 0.7070148341463777 -1.1018067553290878e-07 -0.09994835142032571 +2.7191000000000005 0.7070161381426994 0.7070148625993524 -1.1017311805396057e-07 -0.09994836710615237 +2.7192000000000003 0.7070161651465114 0.7070148910436322 -1.1015008768641699e-07 -0.09994838278721646 +2.7193 0.7070161921423441 0.7070149194790538 -1.1011159443269358e-07 -0.09994839846351938 +2.7194000000000003 0.7070162191303663 0.7070149479054535 -1.1005765187394045e-07 -0.09994841413506263 +2.7195 0.7070162461107461 0.7070149763226681 -1.0998827713534776e-07 -0.09994842980184757 +2.7196000000000002 0.7070162730836516 0.7070150047305347 -1.0990349090869711e-07 -0.09994844546387568 +2.7197000000000005 0.7070163000492505 0.7070150331288907 -1.0980331742807548e-07 -0.09994846112114841 +2.7198 0.7070163270077106 0.7070150615175734 -1.0968778446814043e-07 -0.09994847677366718 +2.7199 0.7070163539591985 0.7070150898964211 -1.095569233475896e-07 -0.09994849242143344 +2.72 0.7070163809038816 0.707015118265272 -1.0941076889793566e-07 -0.09994850806444867 +2.7201000000000004 0.7070164078419261 0.7070151466239649 -1.0924935948432302e-07 -0.09994852370271433 +2.7202 0.7070164347734977 0.7070151749723392 -1.0907273696909858e-07 -0.0999485393362318 +2.7203000000000004 0.7070164616987618 0.7070152033102342 -1.0888094671528126e-07 -0.09994855496500252 +2.7204 0.7070164886178836 0.7070152316374904 -1.0867403757615357e-07 -0.09994857058902801 +2.7205 0.7070165155310268 0.7070152599539483 -1.0845206186403666e-07 -0.0999485862083096 +2.7206000000000006 0.7070165424383557 0.7070152882594496 -1.0821507536416808e-07 -0.09994860182284877 +2.7207000000000003 0.7070165693400329 0.7070153165538362 -1.079631373086809e-07 -0.09994861743264696 +2.7208 0.7070165962362212 0.7070153448369509 -1.0769631035231764e-07 -0.0999486330377057 +2.7209 0.7070166231270818 0.707015373108637 -1.0741466056635868e-07 -0.09994864863802629 +2.721 0.7070166500127761 0.707015401368739 -1.0711825742821396e-07 -0.09994866423361028 +2.7211000000000003 0.7070166768934638 0.7070154296171014 -1.0680717379453475e-07 -0.09994867982445899 +2.7212 0.7070167037693045 0.7070154578535702 -1.064814858864685e-07 -0.09994869541057395 +2.7213000000000003 0.7070167306404562 0.707015486077992 -1.0614127327144424e-07 -0.09994871099195651 +2.7214 0.7070167575070768 0.7070155142902145 -1.0578661885016216e-07 -0.09994872656860823 +2.7215 0.7070167843693227 0.707015542490086 -1.0541760881669499e-07 -0.09994874214053043 +2.7216000000000005 0.7070168112273496 0.7070155706774562 -1.0503433266022266e-07 -0.0999487577077246 +2.7217000000000002 0.7070168380813124 0.7070155988521755 -1.046368831286032e-07 -0.09994877327019223 +2.7218 0.7070168649313645 0.7070156270140953 -1.042253562179643e-07 -0.09994878882793468 +2.7219 0.7070168917776583 0.707015655163068 -1.0379985113800894e-07 -0.09994880438095337 +2.722 0.707016918620345 0.7070156832989474 -1.0336047029900486e-07 -0.09994881992924977 +2.7221 0.7070169454595753 0.707015711421588 -1.0290731927275337e-07 -0.09994883547282525 +2.7222000000000004 0.7070169722954984 0.7070157395308464 -1.0244050678218097e-07 -0.09994885101168138 +2.7223 0.7070169991282615 0.7070157676265791 -1.019601446640428e-07 -0.09994886654581941 +2.7224 0.7070170259580122 0.707015795708645 -1.014663478533101e-07 -0.09994888207524097 +2.7225 0.707017052784895 0.7070158237769038 -1.0095923434153692e-07 -0.09994889759994735 +2.7226000000000004 0.7070170796090546 0.7070158518312162 -1.0043892516731906e-07 -0.09994891311994003 +2.7227 0.7070171064306333 0.7070158798714444 -9.990554437032395e-08 -0.09994892863522042 +2.7228000000000003 0.7070171332497728 0.7070159078974525 -9.935921896873923e-08 -0.09994894414578996 +2.7229 0.7070171600666127 0.7070159359091055 -9.880007892718035e-08 -0.09994895965165009 +2.723 0.707017186881292 0.7070159639062696 -9.822825713066974e-08 -0.09994897515280224 +2.7231000000000005 0.7070172136939473 0.7070159918888133 -9.764388934734025e-08 -0.09994899064924782 +2.7232000000000003 0.7070172405047146 0.7070160198566059 -9.704711419374068e-08 -0.09994900614098833 +2.7233 0.7070172673137276 0.7070160478095183 -9.643807311922326e-08 -0.0999490216280251 +2.7234000000000003 0.707017294121119 0.7070160757474231 -9.58169103504325e-08 -0.0999490371103596 +2.7235 0.7070173209270195 0.7070161036701944 -9.518377287135588e-08 -0.09994905258799325 +2.7236000000000002 0.7070173477315587 0.7070161315777079 -9.453881037995576e-08 -0.09994906806092747 +2.7237000000000005 0.7070173745348637 0.707016159469841 -9.388217525694437e-08 -0.09994908352916367 +2.7238 0.707017401337061 0.7070161873464729 -9.321402253802819e-08 -0.09994909899270332 +2.7239 0.7070174281382746 0.7070162152074841 -9.25345098592642e-08 -0.09994911445154779 +2.724 0.7070174549386274 0.7070162430527578 -9.184379743017168e-08 -0.09994912990569861 +2.7241000000000004 0.70701748173824 0.7070162708821773 -9.114204800250714e-08 -0.09994914535515709 +2.7242 0.7070175085372312 0.7070162986956292 -9.042942681648791e-08 -0.09994916079992472 +2.7243000000000004 0.7070175353357186 0.7070163264930011 -8.97061015799755e-08 -0.09994917624000291 +2.7244 0.7070175621338174 0.7070163542741826 -8.897224241383173e-08 -0.09994919167539304 +2.7245 0.7070175889316408 0.7070163820390652 -8.822802181895906e-08 -0.09994920710609653 +2.7246000000000006 0.7070176157293011 0.7070164097875425 -8.747361462859565e-08 -0.0999492225321149 +2.7247000000000003 0.7070176425269077 0.7070164375195098 -8.670919797882509e-08 -0.09994923795344951 +2.7248 0.7070176693245684 0.7070164652348643 -8.593495126087147e-08 -0.0999492533701018 +2.7249 0.7070176961223891 0.7070164929335051 -8.515105608206813e-08 -0.09994926878207318 +2.725 0.7070177229204735 0.7070165206153334 -8.435769621381595e-08 -0.09994928418936505 +2.7251000000000003 0.7070177497189235 0.7070165482802521 -8.355505755862358e-08 -0.09994929959197882 +2.7252 0.7070177765178391 0.7070165759281665 -8.274332810500468e-08 -0.09994931498991594 +2.7253000000000003 0.7070178033173182 0.7070166035589839 -8.192269788324241e-08 -0.09994933038317781 +2.7254 0.7070178301174563 0.7070166311726136 -8.109335891334779e-08 -0.09994934577176588 +2.7255 0.707017856918347 0.707016658768967 -8.025550517036517e-08 -0.09994936115568154 +2.7256000000000005 0.707017883720082 0.7070166863479579 -7.940933252972848e-08 -0.09994937653492626 +2.7257000000000002 0.7070179105227508 0.7070167139095012 -7.855503873690356e-08 -0.09994939190950142 +2.7258 0.7070179373264405 0.7070167414535149 -7.769282333973393e-08 -0.09994940727940839 +2.7259 0.7070179641312361 0.7070167689799192 -7.682288766241996e-08 -0.09994942264464864 +2.726 0.7070179909372207 0.7070167964886358 -7.594543474393617e-08 -0.0999494380052236 +2.7261 0.7070180177444749 0.7070168239795893 -7.506066929466315e-08 -0.09994945336113462 +2.7262000000000004 0.7070180445530773 0.7070168514527062 -7.41687976547542e-08 -0.09994946871238317 +2.7263 0.707018071363104 0.707016878907915 -7.32700277381905e-08 -0.09994948405897064 +2.7264 0.707018098174629 0.707016906345147 -7.236456898507618e-08 -0.09994949940089848 +2.7265 0.7070181249877243 0.7070169337643355 -7.145263232173973e-08 -0.09994951473816811 +2.7266000000000004 0.707018151802459 0.7070169611654158 -7.053443010045235e-08 -0.09994953007078089 +2.7267 0.7070181786189005 0.7070169885483257 -6.961017605562614e-08 -0.09994954539873825 +2.7268000000000003 0.7070182054371135 0.7070170159130056 -6.868008525350716e-08 -0.0999495607220416 +2.7269 0.7070182322571605 0.7070170432593981 -6.774437404056741e-08 -0.09994957604069239 +2.727 0.7070182590791019 0.7070170705874477 -6.68032599931978e-08 -0.09994959135469199 +2.7271000000000005 0.707018285902995 0.7070170978971017 -6.585696187217174e-08 -0.09994960666404179 +2.7272000000000003 0.7070183127288958 0.7070171251883098 -6.490569956192974e-08 -0.09994962196874335 +2.7273 0.7070183395568571 0.7070171524610238 -6.394969403154815e-08 -0.09994963726879791 +2.7274000000000003 0.7070183663869296 0.7070171797151977 -6.29891672740239e-08 -0.0999496525642069 +2.7275 0.7070183932191614 0.7070172069507886 -6.20243422611716e-08 -0.09994966785497174 +2.7276000000000002 0.7070184200535987 0.7070172341677555 -6.105544288377562e-08 -0.09994968314109391 +2.7277000000000005 0.7070184468902847 0.7070172613660599 -6.008269391039045e-08 -0.09994969842257476 +2.7278000000000002 0.7070184737292609 0.7070172885456658 -5.910632092489057e-08 -0.09994971369941573 +2.7279 0.7070185005705654 0.7070173157065395 -5.812655028201823e-08 -0.09994972897161819 +2.728 0.7070185274142348 0.7070173428486499 -5.714360904883649e-08 -0.09994974423918362 +2.7281000000000004 0.7070185542603022 0.7070173699719682 -5.6157724957458036e-08 -0.09994975950211336 +2.7282 0.7070185811087997 0.7070173970764683 -5.516912634801613e-08 -0.09994977476040887 +2.7283000000000004 0.7070186079597554 0.7070174241621259 -5.4178042118574465e-08 -0.09994979001407148 +2.7284 0.7070186348131959 0.70701745122892 -5.3184701672001275e-08 -0.09994980526310264 +2.7285 0.7070186616691452 0.7070174782768315 -5.218933486110869e-08 -0.09994982050750373 +2.7286000000000006 0.7070186885276242 0.7070175053058443 -5.1192171937044714e-08 -0.0999498357472762 +2.7287000000000003 0.7070187153886522 0.7070175323159442 -5.019344349399893e-08 -0.0999498509824214 +2.7288 0.7070187422522456 0.70701755930712 -4.919338041976286e-08 -0.09994986621294079 +2.7289 0.7070187691184184 0.7070175862793623 -4.8192213836857796e-08 -0.09994988143883575 +2.729 0.7070187959871821 0.7070176132326651 -4.7190175056456216e-08 -0.09994989666010774 +2.7291000000000003 0.7070188228585452 0.7070176401670241 -4.618749551837118e-08 -0.09994991187675806 +2.7292 0.7070188497325147 0.707017667082438 -4.51844067393941e-08 -0.09994992708878819 +2.7293000000000003 0.7070188766090943 0.7070176939789072 -4.41811402620933e-08 -0.09994994229619943 +2.7294 0.7070189034882859 0.7070177208564359 -4.317792759859812e-08 -0.09994995749899332 +2.7295 0.707018930370088 0.7070177477150292 -4.2175000177893164e-08 -0.09994997269717115 +2.7296000000000005 0.7070189572544976 0.7070177745546962 -4.1172589295606146e-08 -0.09994998789073439 +2.7297000000000002 0.7070189841415087 0.7070178013754475 -4.017092605481049e-08 -0.09995000307968445 +2.7298 0.7070190110311128 0.7070178281772967 -3.9170241319594346e-08 -0.09995001826402272 +2.7299 0.7070190379232986 0.7070178549602594 -3.8170765655036465e-08 -0.0999500334437505 +2.73 0.7070190648180533 0.707017881724354 -3.71727292787288e-08 -0.09995004861886932 +2.7301 0.7070190917153606 0.7070179084696013 -3.6176362007162705e-08 -0.09995006378938048 +2.7302000000000004 0.7070191186152024 0.7070179351960246 -3.5181893199729905e-08 -0.09995007895528543 +2.7303 0.707019145517558 0.7070179619036495 -3.418955171101759e-08 -0.09995009411658554 +2.7304 0.7070191724224042 0.7070179885925043 -3.319956583410465e-08 -0.09995010927328225 +2.7305 0.7070191993297151 0.7070180152626198 -3.221216324906205e-08 -0.09995012442537694 +2.7306000000000004 0.707019226239463 0.7070180419140286 -3.1227570970477486e-08 -0.09995013957287105 +2.7307 0.707019253151617 0.7070180685467664 -3.0246015297582043e-08 -0.09995015471576588 +2.7308000000000003 0.7070192800661441 0.707018095160871 -2.926772175895591e-08 -0.09995016985406288 +2.7309 0.7070193069830092 0.7070181217563827 -2.8292915062871904e-08 -0.0999501849877634 +2.731 0.7070193339021745 0.7070181483333442 -2.732181904330222e-08 -0.0999502001168689 +2.7311000000000005 0.7070193608235997 0.7070181748918006 -2.6354656613514563e-08 -0.09995021524138073 +2.7312000000000003 0.7070193877472424 0.7070182014317996 -2.539164970991048e-08 -0.09995023036130032 +2.7313 0.7070194146730576 0.7070182279533908 -2.4433019241935222e-08 -0.09995024547662905 +2.7314000000000003 0.707019441600998 0.7070182544566266 -2.3478985043505485e-08 -0.09995026058736832 +2.7315 0.707019468531014 0.7070182809415614 -2.2529765822485587e-08 -0.0999502756935195 +2.7316000000000003 0.7070194954630536 0.7070183074082521 -2.1585579107561564e-08 -0.09995029079508398 +2.7317000000000005 0.7070195223970626 0.707018333856758 -2.0646641199235233e-08 -0.09995030589206319 +2.7318000000000002 0.7070195493329843 0.7070183602871405 -1.971316712602242e-08 -0.09995032098445847 +2.7319 0.7070195762707597 0.7070183866994635 -1.8785370587207084e-08 -0.09995033607227123 +2.732 0.707019603210328 0.7070184130937931 -1.7863463906871158e-08 -0.09995035115550291 +2.7321000000000004 0.7070196301516254 0.7070184394701977 -1.6947657989659082e-08 -0.09995036623415483 +2.7322 0.7070196570945865 0.7070184658287476 -1.6038162266134026e-08 -0.09995038130822842 +2.7323000000000004 0.7070196840391432 0.707018492169516 -1.5135184646807714e-08 -0.09995039637772507 +2.7324 0.7070197109852255 0.7070185184925777 -1.4238931477904976e-08 -0.09995041144264614 +2.7325 0.707019737932761 0.70701854479801 -1.3349607487587317e-08 -0.09995042650299304 +2.7326000000000006 0.7070197648816754 0.7070185710858922 -1.2467415747789007e-08 -0.09995044155876717 +2.7327000000000004 0.7070197918318916 0.7070185973563059 -1.159255762217537e-08 -0.09995045660996986 +2.7328 0.7070198187833312 0.707018623609335 -1.0725232720172617e-08 -0.09995047165660255 +2.7329 0.7070198457359131 0.7070186498450652 -9.86563885533448e-09 -0.09995048669866664 +2.733 0.707019872689554 0.7070186760635848 -9.013971993300507e-09 -0.09995050173616349 +2.7331000000000003 0.7070198996441694 0.7070187022649834 -8.170426213198467e-09 -0.09995051676909451 +2.7332 0.7070199265996719 0.707018728449353 -7.335193663408901e-09 -0.09995053179746105 +2.7333000000000003 0.707019953555972 0.707018754616788 -6.5084645121255e-09 -0.09995054682126453 +2.7334 0.7070199805129787 0.7070187807673842 -5.690426916130087e-09 -0.09995056184050626 +2.7335 0.7070200074705986 0.7070188069012401 -4.881266963546738e-09 -0.09995057685518768 +2.7336000000000005 0.7070200344287365 0.7070188330184555 -4.081168640014676e-09 -0.09995059186531019 +2.7337000000000002 0.7070200613872959 0.7070188591191329 -3.2903137827181017e-09 -0.09995060687087519 +2.7338 0.7070200883461768 0.7070188852033759 -2.5088820422222713e-09 -0.09995062187188404 +2.7339 0.7070201153052789 0.7070189112712902 -1.7370508408401375e-09 -0.0999506368683381 +2.734 0.7070201422644988 0.7070189373229837 -9.749953336010697e-10 -0.09995065186023872 +2.7341 0.7070201692237323 0.7070189633585662 -2.2288836401540557e-10 -0.09995066684758735 +2.7342000000000004 0.7070201961828725 0.7070189893781489 5.190995714873803e-10 -0.09995068183038536 +2.7343 0.707020223141811 0.7070190153818452 1.2508003582531457e-09 -0.09995069680863411 +2.7344 0.7070202501004377 0.7070190413697699 1.9720483111079767e-09 -0.09995071178233492 +2.7345 0.7070202770586411 0.7070190673420402 2.682680202113763e-09 -0.09995072675148933 +2.7346000000000004 0.7070203040163074 0.7070190932987741 3.3825353048036466e-09 -0.09995074171609862 +2.7347 0.7070203309733212 0.7070191192400921 4.071455430611215e-09 -0.09995075667616418 +2.7348000000000003 0.7070203579295655 0.7070191451661156 4.7492849566260764e-09 -0.09995077163168736 +2.7349 0.7070203848849221 0.7070191710769687 5.415870868961947e-09 -0.09995078658266959 +2.735 0.7070204118392703 0.7070191969727758 6.071062790512227e-09 -0.09995080152911223 +2.7351000000000005 0.7070204387924887 0.7070192228536641 6.714713024318086e-09 -0.09995081647101665 +2.7352000000000003 0.7070204657444537 0.7070192487197615 7.346676575252509e-09 -0.0999508314083842 +2.7353 0.7070204926950403 0.7070192745711981 7.966811191653655e-09 -0.09995084634121634 +2.7354000000000003 0.7070205196441226 0.7070193004081046 8.574977390478355e-09 -0.09995086126951436 +2.7355 0.7070205465915724 0.7070193262306141 9.171038496333384e-09 -0.09995087619327968 +2.7356000000000003 0.7070205735372606 0.7070193520388608 9.754860667496312e-09 -0.09995089111251367 +2.7357000000000005 0.7070206004810564 0.7070193778329799 1.0326312923671088e-08 -0.0999509060272177 +2.7358000000000002 0.7070206274228279 0.7070194036131083 1.0885267183284586e-08 -0.09995092093739312 +2.7359 0.7070206543624414 0.7070194293793846 1.1431598276497035e-08 -0.09995093584304134 +2.736 0.7070206812997628 0.707019455131948 1.1965183995508999e-08 -0.09995095074416371 +2.7361000000000004 0.7070207082346558 0.7070194808709395 1.248590510063291e-08 -0.09995096564076164 +2.7362 0.707020735166983 0.7070195065965011 1.299364536626324e-08 -0.09995098053283646 +2.7363000000000004 0.7070207620966064 0.7070195323087762 1.3488291586948031e-08 -0.09995099542038959 +2.7364 0.7070207890233859 0.707019558007909 1.3969733619022262e-08 -0.09995101030342235 +2.7365 0.7070208159471812 0.7070195836940454 1.4437864398822442e-08 -0.09995102518193615 +2.7366 0.7070208428678504 0.7070196093673318 1.48925799565644e-08 -0.0999510400559323 +2.7367000000000004 0.7070208697852502 0.7070196350279161 1.5333779464915542e-08 -0.09995105492541226 +2.7368 0.7070208966992373 0.7070196606759473 1.576136522858651e-08 -0.09995106979037738 +2.7369 0.7070209236096657 0.7070196863115749 1.6175242734638162e-08 -0.09995108465082891 +2.737 0.7070209505163905 0.7070197119349502 1.657532065074685e-08 -0.09995109950676842 +2.7371000000000003 0.707020977419264 0.7070197375462245 1.696151086683778e-08 -0.09995111435819712 +2.7372 0.7070210043181389 0.7070197631455506 1.733372850028919e-08 -0.09995112920511648 +2.7373000000000003 0.7070210312128663 0.7070197887330819 1.7691891917616387e-08 -0.09995114404752779 +2.7374 0.7070210581032967 0.7070198143089731 1.8035922750084254e-08 -0.0999511588854325 +2.7375 0.7070210849892795 0.7070198398733792 1.8365745914523945e-08 -0.09995117371883189 +2.7376000000000005 0.7070211118706642 0.7070198654264561 1.868128963068011e-08 -0.09995118854772739 +2.7377000000000002 0.7070211387472983 0.7070198909683604 1.8982485428149787e-08 -0.09995120337212031 +2.7378 0.70702116561903 0.7070199164992496 1.9269268172403264e-08 -0.0999512181920121 +2.7379000000000002 0.7070211924857056 0.7070199420192815 1.9541576071722966e-08 -0.09995123300740405 +2.738 0.7070212193471718 0.7070199675286151 1.979935069628541e-08 -0.09995124781829763 +2.7381 0.7070212462032737 0.707019993027409 2.004253698423275e-08 -0.09995126262469409 +2.7382000000000004 0.7070212730538563 0.7070200185158237 2.027108325641791e-08 -0.09995127742659482 +2.7383 0.7070212998987646 0.7070200439940187 2.0484941226812936e-08 -0.09995129222400118 +2.7384 0.7070213267378422 0.7070200694621553 2.068406601031525e-08 -0.09995130701691453 +2.7385 0.7070213535709332 0.7070200949203944 2.0868416138360157e-08 -0.09995132180533627 +2.7386000000000004 0.7070213803978806 0.7070201203688979 2.1037953561522937e-08 -0.09995133658926778 +2.7387 0.7070214072185275 0.7070201458078277 2.1192643659059818e-08 -0.0999513513687104 +2.7388000000000003 0.7070214340327161 0.7070201712373461 2.1332455246714233e-08 -0.09995136614366551 +2.7389 0.7070214608402887 0.7070201966576153 2.1457360583655716e-08 -0.09995138091413441 +2.739 0.7070214876410874 0.7070202220687983 2.1567335375949348e-08 -0.09995139568011849 +2.7391000000000005 0.707021514434954 0.7070202474710583 2.166235877742312e-08 -0.09995141044161912 +2.7392000000000003 0.70702154122173 0.7070202728645585 2.174241340701516e-08 -0.09995142519863767 +2.7393 0.7070215680012566 0.7070202982494622 2.180748533055915e-08 -0.09995143995117549 +2.7394000000000003 0.7070215947733753 0.7070203236259329 2.1857564081601e-08 -0.09995145469923389 +2.7395 0.7070216215379279 0.7070203489941344 2.18926426509905e-08 -0.09995146944281436 +2.7396000000000003 0.7070216482947547 0.7070203743542298 2.1912717500759127e-08 -0.09995148418191813 +2.7397000000000005 0.7070216750436976 0.7070203997063831 2.1917788551109596e-08 -0.09995149891654663 +2.7398000000000002 0.7070217017845976 0.7070204250507575 2.1907859182150602e-08 -0.09995151364670117 +2.7399 0.7070217285172962 0.7070204503875166 2.1882936236498896e-08 -0.09995152837238312 +2.74 0.7070217552416348 0.7070204757168236 2.184303001060567e-08 -0.09995154309359389 +2.7401000000000004 0.7070217819574551 0.707020501038842 2.1788154259093362e-08 -0.09995155781033477 +2.7402 0.7070218086645985 0.7070205263537344 2.1718326180010517e-08 -0.09995157252260711 +2.7403000000000004 0.7070218353629075 0.7070205516616639 2.1633566416566496e-08 -0.09995158723041234 +2.7404 0.7070218620522244 0.7070205769627929 2.153389905279468e-08 -0.0999516019337518 +2.7405 0.7070218887323916 0.7070206022572834 2.1419351610083015e-08 -0.09995161663262679 +2.7406 0.707021915403252 0.7070206275452974 2.1289955026357332e-08 -0.09995163132703867 +2.7407000000000004 0.7070219420646492 0.7070206528269964 2.114574366041816e-08 -0.09995164601698887 +2.7408 0.7070219687164265 0.7070206781025415 2.0986755271991397e-08 -0.09995166070247868 +2.7409 0.7070219953584285 0.7070207033720932 2.0813031026065132e-08 -0.09995167538350946 +2.741 0.7070220219904996 0.7070207286358117 2.0624615474675034e-08 -0.09995169006008256 +2.7411000000000003 0.7070220486124852 0.7070207538938567 2.0421556537822405e-08 -0.09995170473219939 +2.7412 0.7070220752242308 0.707020779146387 2.0203905508678344e-08 -0.09995171939986124 +2.7413000000000003 0.7070221018255828 0.7070208043935613 1.9971717025828173e-08 -0.09995173406306947 +2.7414 0.7070221284163883 0.7070208296355371 1.9725049067199907e-08 -0.09995174872182545 +2.7415 0.7070221549964946 0.7070208548724719 1.9463962932717016e-08 -0.09995176337613049 +2.7416000000000005 0.7070221815657503 0.707020880104522 1.9188523231288e-08 -0.09995177802598598 +2.7417000000000002 0.7070222081240042 0.707020905331843 1.889879785825499e-08 -0.09995179267139322 +2.7418 0.7070222346711064 0.7070209305545903 1.8594857996261094e-08 -0.09995180731235366 +2.7419000000000002 0.707022261206907 0.7070209557729177 1.8276778074484412e-08 -0.09995182194886852 +2.742 0.7070222877312581 0.7070209809869786 1.7944635763433858e-08 -0.09995183658093929 +2.7421 0.7070223142440117 0.7070210061969255 1.7598511956734564e-08 -0.09995185120856724 +2.7422000000000004 0.7070223407450213 0.7070210314029101 1.7238490748576474e-08 -0.09995186583175375 +2.7423 0.7070223672341408 0.7070210566050826 1.686465941636711e-08 -0.09995188045050013 +2.7424 0.7070223937112255 0.7070210818035929 1.647710839557809e-08 -0.09995189506480777 +2.7425 0.7070224201761316 0.7070211069985892 1.6075931256326337e-08 -0.09995190967467794 +2.7426000000000004 0.707022446628716 0.7070211321902193 1.5661224686026876e-08 -0.09995192428011204 +2.7427 0.7070224730688371 0.7070211573786298 1.5233088468576128e-08 -0.09995193888111138 +2.7428000000000003 0.7070224994963548 0.7070211825639658 1.4791625444453282e-08 -0.0999519534776774 +2.7429 0.7070225259111291 0.707021207746372 1.433694150985293e-08 -0.09995196806981141 +2.743 0.7070225523130218 0.7070212329259911 1.3869145571582253e-08 -0.09995198265751469 +2.7431000000000005 0.7070225787018962 0.7070212581029649 1.3388349538387412e-08 -0.09995199724078868 +2.7432000000000003 0.707022605077616 0.7070212832774339 1.2894668268044474e-08 -0.09995201181963462 +2.7433 0.7070226314400467 0.7070213084495375 1.23882195699615e-08 -0.0999520263940539 +2.7434000000000003 0.7070226577890553 0.7070213336194138 1.1869124154871569e-08 -0.09995204096404786 +2.7435 0.7070226841245093 0.7070213587871995 1.1337505618352894e-08 -0.09995205552961783 +2.7436000000000003 0.7070227104462787 0.7070213839530297 1.0793490410471174e-08 -0.09995207009076514 +2.7437000000000005 0.7070227367542342 0.7070214091170388 1.023720779414622e-08 -0.09995208464749124 +2.7438000000000002 0.707022763048248 0.7070214342793592 9.668789838213065e-09 -0.0999520991997974 +2.7439 0.7070227893281937 0.7070214594401216 9.088371354971925e-09 -0.09995211374768494 +2.744 0.7070228155939464 0.707021484599456 8.496089890647207e-09 -0.09995212829115524 +2.7441000000000004 0.7070228418453832 0.7070215097574901 7.892085692427775e-09 -0.09995214283020962 +2.7442 0.7070228680823817 0.7070215349143505 7.276501665098856e-09 -0.09995215736484937 +2.7443 0.7070228943048222 0.7070215600701624 6.6494833363475725e-09 -0.09995217189507594 +2.7444 0.7070229205125858 0.7070215852250483 6.011178834211539e-09 -0.0999521864208905 +2.7445 0.7070229467055558 0.7070216103791311 5.361738840241326e-09 -0.09995220094229462 +2.7446 0.7070229728836166 0.7070216355325305 4.701316565214331e-09 -0.09995221545928949 +2.7447000000000004 0.7070229990466547 0.7070216606853645 4.030067705766693e-09 -0.09995222997187647 +2.7448 0.707023025194558 0.70702168583775 3.348150407964101e-09 -0.09995224448005689 +2.7449 0.7070230513272162 0.7070217109898023 2.6557252317399582e-09 -0.09995225898383212 +2.745 0.7070230774445208 0.707021736141634 1.9529551118641075e-09 -0.09995227348320342 +2.7451000000000003 0.7070231035463651 0.707021761293357 1.2400053223809993e-09 -0.09995228797817218 +2.7452 0.7070231296326445 0.707021786445081 5.170434297721571e-10 -0.09995230246873978 +2.7453000000000003 0.7070231557032556 0.7070218115969131 -2.157607304625886e-10 -0.09995231695490746 +2.7454 0.7070231817580973 0.7070218367489601 -9.582351162551461e-10 -0.09995233143667664 +2.7455 0.7070232077970702 0.7070218619013259 -1.710205496316397e-09 -0.09995234591404864 +2.7456000000000005 0.707023233820077 0.7070218870541125 -2.4714955030452623e-09 -0.0999523603870248 +2.7457000000000003 0.707023259827022 0.70702191220742 -3.241926679366236e-09 -0.0999523748556064 +2.7458 0.7070232858178118 0.7070219373613469 -4.021318503015514e-09 -0.09995238931979483 +2.7459000000000002 0.7070233117923546 0.7070219625159894 -4.809488443786869e-09 -0.09995240377959136 +2.746 0.7070233377505608 0.7070219876714419 -5.606252005165013e-09 -0.09995241823499741 +2.7461 0.7070233636923426 0.7070220128277969 -6.4114227607547924e-09 -0.0999524326860142 +2.7462000000000004 0.7070233896176148 0.7070220379851443 -7.2248124019860804e-09 -0.09995244713264313 +2.7463 0.7070234155262936 0.7070220631435729 -8.046230780614505e-09 -0.09995246157488556 +2.7464 0.7070234414182974 0.707022088303169 -8.875485952956896e-09 -0.09995247601274286 +2.7465 0.7070234672935469 0.7070221134640164 -9.712384224994097e-09 -0.09995249044621625 +2.7466000000000004 0.7070234931519648 0.7070221386261972 -1.0556730201810582e-08 -0.0999525048753071 +2.7467 0.7070235189934758 0.7070221637897913 -1.1408326824023651e-08 -0.09995251930001674 +2.7468000000000004 0.7070235448180069 0.7070221889548762 -1.2266975425029303e-08 -0.09995253372034649 +2.7469 0.707023570625487 0.7070222141215281 -1.3132475770033514e-08 -0.0999525481362977 +2.747 0.7070235964158474 0.70702223928982 -1.4004626100721368e-08 -0.09995256254787167 +2.7471000000000005 0.707023622189022 0.7070222644598233 -1.4883223189033484e-08 -0.09995257695506979 +2.7472000000000003 0.7070236479449461 0.707022289631607 -1.5768062381401465e-08 -0.09995259135789333 +2.7473 0.7070236736835576 0.707022314805238 -1.6658937642983346e-08 -0.09995260575634367 +2.7474000000000003 0.7070236994047963 0.7070223399807807 -1.7555641613608425e-08 -0.09995262015042204 +2.7475 0.707023725108605 0.7070223651582979 -1.8457965647242225e-08 -0.09995263454012987 +2.7476000000000003 0.7070237507949279 0.7070223903378492 -1.93656998661966e-08 -0.0999526489254684 +2.7477000000000005 0.7070237764637122 0.7070224155194929 -2.027863320623255e-08 -0.09995266330643907 +2.7478000000000002 0.7070238021149066 0.7070224407032839 -2.119655347207136e-08 -0.09995267768304304 +2.7479 0.7070238277484628 0.7070224658892762 -2.2119247378594303e-08 -0.09995269205528179 +2.748 0.7070238533643349 0.7070224910775202 -2.304650060678745e-08 -0.09995270642315658 +2.7481000000000004 0.7070238789624784 0.7070225162680651 -2.3978097847109775e-08 -0.09995272078666878 +2.7482 0.7070239045428517 0.707022541460957 -2.4913822855871653e-08 -0.09995273514581965 +2.7483 0.7070239301054158 0.7070225666562394 -2.5853458502072407e-08 -0.0999527495006105 +2.7484 0.7070239556501334 0.7070225918539544 -2.679678681770728e-08 -0.09995276385104272 +2.7485 0.7070239811769699 0.7070226170541412 -2.774358904894178e-08 -0.09995277819711756 +2.7486 0.7070240066858935 0.7070226422568369 -2.8693645708803908e-08 -0.09995279253883643 +2.7487000000000004 0.7070240321768739 0.7070226674620756 -2.964673662445537e-08 -0.09995280687620058 +2.7488 0.7070240576498839 0.7070226926698902 -3.060264098901644e-08 -0.09995282120921142 +2.7489 0.707024083104898 0.7070227178803099 -3.156113741599291e-08 -0.09995283553787018 +2.749 0.7070241085418938 0.7070227430933624 -3.252200398567995e-08 -0.09995284986217827 +2.7491000000000003 0.7070241339608505 0.7070227683090727 -3.348501829915536e-08 -0.09995286418213689 +2.7492 0.7070241593617507 0.7070227935274633 -3.444995753010445e-08 -0.09995287849774744 +2.7493000000000003 0.7070241847445782 0.7070228187485545 -3.541659847642806e-08 -0.0999528928090112 +2.7494 0.7070242101093203 0.7070228439723641 -3.638471760946532e-08 -0.09995290711592952 +2.7495 0.707024235455966 0.7070228691989076 -3.735409112798696e-08 -0.0999529214185037 +2.7496000000000005 0.7070242607845073 0.7070228944281981 -3.8324495010670645e-08 -0.0999529357167351 +2.7497000000000003 0.7070242860949381 0.707022919660246 -3.9295705064239586e-08 -0.09995295001062504 +2.7498 0.7070243113872546 0.7070229448950598 -4.026749697761843e-08 -0.09995296430017477 +2.7499000000000002 0.7070243366614559 0.7070229701326449 -4.123964637440863e-08 -0.09995297858538563 +2.75 0.7070243619175429 0.707022995373005 -4.221192886455071e-08 -0.09995299286625894 +2.7501 0.7070243871555197 0.707023020616141 -4.3184120094604114e-08 -0.09995300714279604 +2.7502000000000004 0.7070244123753922 0.7070230458620512 -4.4155995799260365e-08 -0.09995302141499818 +2.7503 0.707024437577169 0.707023071110732 -4.512733185502464e-08 -0.09995303568286676 +2.7504 0.7070244627608611 0.7070230963621771 -4.609790433076667e-08 -0.09995304994640306 +2.7505 0.7070244879264816 0.707023121616378 -4.706748953987091e-08 -0.0999530642056084 +2.7506000000000004 0.7070245130740465 0.7070231468733235 -4.803586408936439e-08 -0.09995307846048412 +2.7507 0.7070245382035737 0.7070231721330003 -4.9002804936091986e-08 -0.0999530927110315 +2.7508000000000004 0.7070245633150836 0.707023197395392 -4.996808943382499e-08 -0.09995310695725185 +2.7509 0.7070245884085994 0.7070232226604809 -5.093149538519439e-08 -0.0999531211991465 +2.751 0.707024613484146 0.7070232479282463 -5.1892801095684143e-08 -0.09995313543671676 +2.7511000000000005 0.7070246385417512 0.707023273198665 -5.285178542166133e-08 -0.0999531496699639 +2.7512000000000003 0.707024663581445 0.7070232984717119 -5.3808227821767335e-08 -0.09995316389888928 +2.7513 0.7070246886032596 0.7070233237473589 -5.4761908407658516e-08 -0.09995317812349418 +2.7514000000000003 0.7070247136072301 0.7070233490255766 -5.57126079955058e-08 -0.09995319234377999 +2.7515 0.707024738593393 0.7070233743063319 -5.66601081543501e-08 -0.0999532065597479 +2.7516000000000003 0.7070247635617881 0.7070233995895906 -5.760419126052928e-08 -0.09995322077139934 +2.7517000000000005 0.707024788512457 0.7070234248753151 -5.8544640542780926e-08 -0.09995323497873553 +2.7518000000000002 0.7070248134454439 0.7070234501634665 -5.94812401342841e-08 -0.09995324918175785 +2.7519 0.7070248383607949 0.7070234754540026 -6.041377512188209e-08 -0.09995326338046753 +2.752 0.7070248632585586 0.7070235007468797 -6.13420315948715e-08 -0.09995327757486594 +2.7521000000000004 0.7070248881387861 0.7070235260420514 -6.22657966944419e-08 -0.09995329176495435 +2.7522 0.7070249130015306 0.7070235513394693 -6.31848586646333e-08 -0.09995330595073414 +2.7523 0.7070249378468476 0.7070235766390823 -6.409900689353584e-08 -0.09995332013220654 +2.7524 0.7070249626747946 0.7070236019408376 -6.500803197400512e-08 -0.09995333430937291 +2.7525 0.7070249874854317 0.7070236272446797 -6.591172574009138e-08 -0.09995334848223451 +2.7526 0.7070250122788208 0.7070236525505511 -6.680988131778018e-08 -0.09995336265079266 +2.7527000000000004 0.7070250370550264 0.7070236778583923 -6.770229317790144e-08 -0.09995337681504865 +2.7528 0.7070250618141152 0.7070237031681408 -6.85887571738597e-08 -0.09995339097500383 +2.7529 0.7070250865561558 0.7070237284797333 -6.946907059801263e-08 -0.09995340513065953 +2.753 0.7070251112812189 0.7070237537931027 -7.034303221853389e-08 -0.09995341928201695 +2.7531000000000003 0.707025135989378 0.7070237791081813 -7.121044233102114e-08 -0.09995343342907748 +2.7532 0.7070251606807076 0.707023804424898 -7.207110280620099e-08 -0.09995344757184238 +2.7533000000000003 0.7070251853552856 0.7070238297431806 -7.292481712939392e-08 -0.099953461710313 +2.7534 0.7070252100131906 0.7070238550629542 -7.377139045038755e-08 -0.09995347584449057 +2.7535 0.7070252346545047 0.7070238803841419 -7.461062962420273e-08 -0.09995348997437646 +2.7536000000000005 0.7070252592793109 0.7070239057066647 -7.544234325619625e-08 -0.09995350409997192 +2.7537000000000003 0.7070252838876951 0.7070239310304421 -7.626634174542901e-08 -0.09995351822127829 +2.7538 0.7070253084797447 0.7070239563553912 -7.708243732976877e-08 -0.09995353233829687 +2.7539000000000002 0.7070253330555489 0.7070239816814265 -7.789044412492147e-08 -0.09995354645102894 +2.754 0.7070253576151997 0.7070240070084618 -7.869017817300344e-08 -0.09995356055947585 +2.7541 0.7070253821587902 0.7070240323364081 -7.94814574737665e-08 -0.09995357466363888 +2.7542000000000004 0.7070254066864158 0.7070240576651745 -8.026410204444584e-08 -0.09995358876351931 +2.7543 0.7070254311981736 0.7070240829946683 -8.103793393537256e-08 -0.09995360285911845 +2.7544 0.7070254556941631 0.7070241083247951 -8.180277729415847e-08 -0.09995361695043758 +2.7545 0.7070254801744849 0.7070241336554584 -8.255845839171688e-08 -0.099953631037478 +2.7546000000000004 0.7070255046392422 0.7070241589865599 -8.330480566736548e-08 -0.09995364512024102 +2.7547 0.7070255290885394 0.7070241843179994 -8.404164976178602e-08 -0.09995365919872792 +2.7548000000000004 0.7070255535224832 0.7070242096496754 -8.476882356212717e-08 -0.09995367327294004 +2.7549 0.7070255779411818 0.707024234981484 -8.548616223583161e-08 -0.09995368734287868 +2.755 0.707025602344745 0.7070242603133199 -8.619350326966729e-08 -0.09995370140854509 +2.7551000000000005 0.7070256267332848 0.7070242856450762 -8.689068651049348e-08 -0.09995371546994065 +2.7552000000000003 0.7070256511069141 0.7070243109766439 -8.757755419388363e-08 -0.09995372952706655 +2.7553 0.7070256754657481 0.7070243363079126 -8.825395098228939e-08 -0.09995374357992415 +2.7554000000000003 0.7070256998099036 0.70702436163877 -8.89197239988676e-08 -0.0999537576285147 +2.7555 0.7070257241394989 0.7070243869691026 -8.95747228708485e-08 -0.09995377167283954 +2.7556000000000003 0.7070257484546536 0.7070244122987952 -9.021879975382174e-08 -0.09995378571289992 +2.7557000000000005 0.7070257727554894 0.7070244376277308 -9.085180936382886e-08 -0.09995379974869717 +2.7558000000000002 0.7070257970421292 0.7070244629557912 -9.147360901812923e-08 -0.09995381378023263 +2.7559 0.7070258213146975 0.7070244882828565 -9.208405866469038e-08 -0.09995382780750751 +2.756 0.70702584557332 0.7070245136088051 -9.268302091167829e-08 -0.09995384183052315 +2.7561000000000004 0.7070258698181241 0.7070245389335144 -9.327036105521297e-08 -0.09995385584928078 +2.7562 0.7070258940492387 0.7070245642568602 -9.384594711926708e-08 -0.09995386986378176 +2.7563 0.7070259182667935 0.7070245895787168 -9.440964987821737e-08 -0.09995388387402732 +2.7564 0.7070259424709209 0.7070246148989576 -9.496134288633495e-08 -0.09995389788001884 +2.7565 0.7070259666617529 0.7070246402174539 -9.550090250380616e-08 -0.0999539118817575 +2.7566 0.7070259908394241 0.7070246655340766 -9.602820793142702e-08 -0.09995392587924473 +2.7567000000000004 0.7070260150040698 0.7070246908486945 -9.65431412322873e-08 -0.09995393987248172 +2.7568 0.7070260391558265 0.7070247161611758 -9.704558736126079e-08 -0.0999539538614698 +2.7569 0.707026063294832 0.707024741471387 -9.753543418929145e-08 -0.09995396784621022 +2.757 0.7070260874212251 0.7070247667791939 -9.801257252681217e-08 -0.09995398182670426 +2.7571000000000003 0.7070261115351464 0.707024792084461 -9.847689615150035e-08 -0.09995399580295329 +2.7572 0.7070261356367367 0.707024817387051 -9.892830182302303e-08 -0.09995400977495848 +2.7573000000000003 0.7070261597261386 0.7070248426868271 -9.936668932293558e-08 -0.09995402374272126 +2.7574 0.7070261838034952 0.7070248679836498 -9.979196145641633e-08 -0.09995403770624278 +2.7575 0.7070262078689511 0.7070248932773799 -1.0020402408696116e-07 -0.09995405166552446 +2.7576000000000005 0.7070262319226512 0.7070249185678763 -1.0060278615806745e-07 -0.09995406562056752 +2.7577000000000003 0.7070262559647422 0.7070249438549974 -1.0098815970797925e-07 -0.09995407957137324 +2.7578 0.707026279995371 0.7070249691386005 -1.0136005988876928e-07 -0.09995409351794288 +2.7579000000000002 0.7070263040146857 0.7070249944185423 -1.0171840498889029e-07 -0.09995410746027783 +2.758 0.7070263280228347 0.7070250196946779 -1.0206311644792021e-07 -0.09995412139837917 +2.7581 0.7070263520199682 0.707025044966863 -1.0239411887477678e-07 -0.09995413533224838 +2.7582000000000004 0.7070263760062365 0.7070250702349514 -1.027113400598606e-07 -0.09995414926188667 +2.7583 0.7070263999817907 0.7070250954987962 -1.0301471099847387e-07 -0.09995416318729532 +2.7584 0.707026423946783 0.7070251207582506 -1.0330416590469821e-07 -0.09995417710847568 +2.7585 0.7070264479013653 0.7070251460131662 -1.0357964221920091e-07 -0.09995419102542896 +2.7586000000000004 0.7070264718456913 0.7070251712633948 -1.0384108062744951e-07 -0.09995420493815649 +2.7587 0.7070264957799143 0.7070251965087868 -1.0408842507532434e-07 -0.0999542188466595 +2.7588000000000004 0.7070265197041892 0.7070252217491926 -1.0432162277432266e-07 -0.09995423275093934 +2.7589 0.7070265436186702 0.7070252469844613 -1.0454062421543647e-07 -0.09995424665099717 +2.759 0.7070265675235131 0.7070252722144428 -1.0474538317869347e-07 -0.09995426054683437 +2.7591000000000006 0.7070265914188736 0.7070252974389855 -1.049358567487696e-07 -0.09995427443845219 +2.7592000000000003 0.7070266153049078 0.7070253226579377 -1.0511200531498899e-07 -0.09995428832585194 +2.7593 0.7070266391817727 0.7070253478711479 -1.05273792580865e-07 -0.09995430220903494 +2.7594000000000003 0.7070266630496246 0.7070253730784631 -1.0542118557884533e-07 -0.09995431608800237 +2.7595 0.7070266869086212 0.7070253982797308 -1.0555415467204676e-07 -0.09995432996275559 +2.7596000000000003 0.7070267107589198 0.7070254234747978 -1.0567267356206139e-07 -0.0999543438332958 +2.7597000000000005 0.7070267346006784 0.7070254486635109 -1.057767192880893e-07 -0.09995435769962435 +2.7598000000000003 0.7070267584340546 0.7070254738457169 -1.0586627223734685e-07 -0.09995437156174247 +2.7599 0.707026782259207 0.7070254990212619 -1.0594131614506674e-07 -0.09995438541965147 +2.76 0.7070268060762936 0.7070255241899923 -1.0600183810230424e-07 -0.09995439927335262 +2.7601000000000004 0.7070268298854727 0.7070255493517541 -1.0604782855246769e-07 -0.09995441312284715 +2.7602 0.707026853686903 0.7070255745063936 -1.0607928128958388e-07 -0.09995442696813645 +2.7603 0.7070268774807427 0.7070255996537566 -1.0609619347477783e-07 -0.09995444080922165 +2.7604 0.7070269012671506 0.7070256247936892 -1.0609856561285408e-07 -0.09995445464610415 +2.7605 0.7070269250462848 0.7070256499260376 -1.0608640156964388e-07 -0.09995446847878518 +2.7606 0.7070269488183037 0.7070256750506482 -1.0605970856593372e-07 -0.09995448230726602 +2.7607000000000004 0.7070269725833653 0.7070257001673668 -1.060184971627201e-07 -0.09995449613154787 +2.7608 0.7070269963416278 0.7070257252760405 -1.0596278127422004e-07 -0.09995450995163212 +2.7609 0.7070270200932492 0.7070257503765155 -1.0589257815746267e-07 -0.09995452376752 +2.761 0.7070270438383871 0.7070257754686391 -1.0580790840448301e-07 -0.0999545375792128 +2.7611000000000003 0.7070270675771987 0.707025800552258 -1.0570879593798516e-07 -0.09995455138671178 +2.7612 0.7070270913098408 0.7070258256272197 -1.0559526800440339e-07 -0.09995456519001815 +2.7613000000000003 0.7070271150364705 0.7070258506933723 -1.0546735517216743e-07 -0.09995457898913328 +2.7614 0.707027138757244 0.7070258757505636 -1.0532509131782469e-07 -0.09995459278405835 +2.7615 0.7070271624723176 0.7070259007986424 -1.0516851361649926e-07 -0.09995460657479471 +2.7616000000000005 0.707027186181846 0.7070259258374574 -1.0499766253495302e-07 -0.09995462036134356 +2.7617000000000003 0.7070272098859851 0.7070259508668584 -1.0481258182204467e-07 -0.09995463414370626 +2.7618 0.7070272335848888 0.707025975886695 -1.0461331849398459e-07 -0.099954647921884 +2.7619000000000002 0.7070272572787117 0.7070260008968181 -1.0439992282219174e-07 -0.0999546616958781 +2.762 0.7070272809676068 0.7070260258970787 -1.0417244833069161e-07 -0.09995467546568985 +2.7621 0.7070273046517268 0.7070260508873285 -1.0393095177356482e-07 -0.09995468923132048 +2.7622000000000004 0.707027328331224 0.70702607586742 -1.03675493122804e-07 -0.09995470299277123 +2.7623 0.7070273520062496 0.7070261008372059 -1.0340613554662981e-07 -0.09995471675004342 +2.7624 0.7070273756769547 0.70702612579654 -1.0312294540775618e-07 -0.0999547305031383 +2.7625 0.7070273993434887 0.7070261507452771 -1.0282599223910421e-07 -0.0999547442520571 +2.7626000000000004 0.7070274230060013 0.7070261756832725 -1.025153487264549e-07 -0.09995475799680117 +2.7627 0.7070274466646406 0.7070262006103821 -1.0219109069370402e-07 -0.09995477173737172 +2.7628000000000004 0.707027470319554 0.7070262255264632 -1.0185329707684126e-07 -0.09995478547377001 +2.7629 0.7070274939708886 0.7070262504313733 -1.015020499178787e-07 -0.09995479920599736 +2.763 0.7070275176187897 0.7070262753249713 -1.0113743433622785e-07 -0.09995481293405498 +2.7631000000000006 0.7070275412634022 0.707026300207117 -1.00759538507883e-07 -0.09995482665794415 +2.7632000000000003 0.7070275649048698 0.7070263250776707 -1.0036845364807395e-07 -0.09995484037766615 +2.7633 0.7070275885433353 0.707026349936495 -9.996427398177576e-08 -0.09995485409322225 +2.7634000000000003 0.70702761217894 0.7070263747834518 -9.954709673503509e-08 -0.09995486780461363 +2.7635 0.707027635811825 0.7070263996184055 -9.911702210114309e-08 -0.0999548815118417 +2.7636000000000003 0.7070276594421299 0.7070264244412208 -9.867415321114514e-08 -0.09995489521490758 +2.7637000000000005 0.7070276830699925 0.7070264492517637 -9.821859612083039e-08 -0.09995490891381265 +2.7638000000000003 0.7070277066955506 0.7070264740499022 -9.775045978384356e-08 -0.09995492260855815 +2.7639 0.7070277303189396 0.7070264988355038 -9.726985602306198e-08 -0.09995493629914524 +2.764 0.7070277539402946 0.7070265236084391 -9.67768994976359e-08 -0.0999549499855753 +2.7641000000000004 0.7070277775597487 0.7070265483685785 -9.627170768737592e-08 -0.09995496366784952 +2.7642 0.7070278011774346 0.7070265731157946 -9.575440086066062e-08 -0.09995497734596924 +2.7643 0.7070278247934826 0.7070265978499609 -9.522510203800738e-08 -0.09995499101993563 +2.7644 0.7070278484080226 0.7070266225709525 -9.46839369738578e-08 -0.09995500468975 +2.7645 0.7070278720211822 0.7070266472786455 -9.413103412101581e-08 -0.09995501835541358 +2.7646 0.7070278956330889 0.7070266719729181 -9.35665246020248e-08 -0.0999550320169277 +2.7647000000000004 0.7070279192438672 0.7070266966536494 -9.299054217794256e-08 -0.09995504567429359 +2.7648 0.7070279428536411 0.7070267213207198 -9.240322321538152e-08 -0.09995505932751246 +2.7649 0.7070279664625331 0.7070267459740116 -9.18047066526817e-08 -0.09995507297658562 +2.765 0.7070279900706636 0.7070267706134084 -9.119513397215506e-08 -0.09995508662151427 +2.7651000000000003 0.7070280136781519 0.7070267952387956 -9.057464916625846e-08 -0.09995510026229974 +2.7652 0.7070280372851159 0.7070268198500602 -8.994339869422552e-08 -0.09995511389894324 +2.7653000000000003 0.707028060891671 0.7070268444470902 -8.930153146385206e-08 -0.099955127531446 +2.7654 0.7070280844979322 0.7070268690297759 -8.864919877945437e-08 -0.09995514115980934 +2.7655 0.7070281081040121 0.707026893598009 -8.79865543158484e-08 -0.09995515478403451 +2.7656000000000005 0.7070281317100215 0.7070269181516831 -8.731375408278785e-08 -0.09995516840412277 +2.7657000000000003 0.7070281553160701 0.7070269426906928 -8.66309563833309e-08 -0.09995518202007532 +2.7658 0.7070281789222652 0.7070269672149353 -8.593832178001304e-08 -0.09995519563189348 +2.7659000000000002 0.7070282025287129 0.7070269917243089 -8.52360130558158e-08 -0.09995520923957843 +2.766 0.7070282261355172 0.7070270162187144 -8.452419517600285e-08 -0.0999552228431315 +2.7661000000000002 0.7070282497427802 0.7070270406980534 -8.38030352516908e-08 -0.0999552364425539 +2.7662000000000004 0.7070282733506026 0.7070270651622305 -8.307270249561377e-08 -0.09995525003784693 +2.7663 0.7070282969590829 0.707027089611151 -8.233336818569414e-08 -0.09995526362901175 +2.7664 0.707028320568318 0.7070271140447227 -8.158520562427662e-08 -0.09995527721604974 +2.7665 0.7070283441784027 0.7070271384628555 -8.08283901043011e-08 -0.09995529079896211 +2.7666000000000004 0.7070283677894297 0.7070271628654603 -8.006309885639357e-08 -0.09995530437775002 +2.7667 0.7070283914014903 0.707027187252451 -7.928951101330434e-08 -0.09995531795241483 +2.7668000000000004 0.7070284150146737 0.7070272116237424 -7.850780756480519e-08 -0.09995533152295773 +2.7669 0.7070284386290671 0.7070272359792522 -7.771817132386227e-08 -0.09995534508938002 +2.767 0.707028462244755 0.7070272603188996 -7.692078687112497e-08 -0.09995535865168288 +2.7671000000000006 0.7070284858618211 0.7070272846426059 -7.61158405271703e-08 -0.09995537220986765 +2.7672000000000003 0.7070285094803463 0.7070273089502943 -7.530352029612442e-08 -0.09995538576393548 +2.7673 0.7070285331004096 0.7070273332418904 -7.44840158274987e-08 -0.09995539931388771 +2.7674000000000003 0.7070285567220883 0.7070273575173216 -7.365751836675011e-08 -0.09995541285972556 +2.7675 0.7070285803454569 0.7070273817765169 -7.282422072102043e-08 -0.09995542640145022 +2.7676000000000003 0.7070286039705886 0.7070274060194086 -7.198431720362511e-08 -0.09995543993906306 +2.7677000000000005 0.707028627597554 0.7070274302459296 -7.113800359372091e-08 -0.09995545347256518 +2.7678000000000003 0.7070286512264219 0.7070274544560167 -7.02854770920705e-08 -0.09995546700195795 +2.7679 0.7070286748572583 0.7070274786496069 -6.942693626943441e-08 -0.09995548052724257 +2.768 0.7070286984901277 0.7070275028266406 -6.856258102797344e-08 -0.09995549404842026 +2.7681000000000004 0.7070287221250927 0.7070275269870603 -6.769261254747222e-08 -0.09995550756549235 +2.7682 0.7070287457622129 0.7070275511308102 -6.68172332428385e-08 -0.09995552107845998 +2.7683 0.707028769401546 0.707027575257837 -6.59366467133625e-08 -0.09995553458732451 +2.7684 0.707028793043148 0.7070275993680892 -6.505105770195085e-08 -0.09995554809208708 +2.7685 0.707028816687072 0.7070276234615184 -6.416067204395234e-08 -0.09995556159274904 +2.7686 0.7070288403333691 0.7070276475380772 -6.326569661554982e-08 -0.09995557508931152 +2.7687000000000004 0.7070288639820884 0.7070276715977216 -6.236633929039212e-08 -0.09995558858177583 +2.7688 0.7070288876332763 0.7070276956404091 -6.14628088897208e-08 -0.0999556020701432 +2.7689 0.7070289112869774 0.7070277196660997 -6.055531513553258e-08 -0.09995561555441485 +2.769 0.7070289349432339 0.7070277436747554 -5.964406859983867e-08 -0.09995562903459204 +2.7691000000000003 0.7070289586020855 0.707027767666341 -5.872928065674306e-08 -0.09995564251067601 +2.7692 0.7070289822635702 0.7070277916408234 -5.7811163431918666e-08 -0.09995565598266805 +2.7693000000000003 0.7070290059277229 0.7070278155981716 -5.688992975533616e-08 -0.09995566945056937 +2.7694 0.7070290295945769 0.707027839538357 -5.5965793112908516e-08 -0.09995568291438123 +2.7695 0.7070290532641628 0.7070278634613529 -5.503896759509984e-08 -0.09995569637410481 +2.7696000000000005 0.7070290769365087 0.7070278873671356 -5.4109667846184706e-08 -0.09995570982974136 +2.7697000000000003 0.7070291006116411 0.7070279112556833 -5.317810901849483e-08 -0.09995572328129217 +2.7698 0.7070291242895836 0.7070279351269766 -5.224450671885948e-08 -0.09995573672875845 +2.7699000000000003 0.7070291479703579 0.7070279589809987 -5.1309076959599534e-08 -0.09995575017214145 +2.77 0.7070291716539826 0.7070279828177344 -5.037203610897944e-08 -0.09995576361144236 +2.7701000000000002 0.7070291953404751 0.7070280066371717 -4.943360084274338e-08 -0.09995577704666253 +2.7702000000000004 0.7070292190298497 0.7070280304393002 -4.849398809218201e-08 -0.09995579047780312 +2.7703 0.7070292427221185 0.7070280542241125 -4.755341499501804e-08 -0.09995580390486541 +2.7704 0.7070292664172911 0.7070280779916027 -4.66120988438525e-08 -0.09995581732785058 +2.7705 0.7070292901153754 0.707028101741768 -4.567025703629138e-08 -0.0999558307467599 +2.7706000000000004 0.7070293138163761 0.7070281254746075 -4.4728107026427606e-08 -0.0999558441615946 +2.7707 0.7070293375202963 0.7070281491901227 -4.378586627231144e-08 -0.09995585757235592 +2.7708000000000004 0.707029361227136 0.7070281728883179 -4.2843752188963876e-08 -0.09995587097904508 +2.7709 0.7070293849368938 0.7070281965691989 -4.1901982093759944e-08 -0.09995588438166333 +2.771 0.7070294086495655 0.7070282202327748 -4.0960773160390786e-08 -0.09995589778021197 +2.7711000000000006 0.7070294323651444 0.7070282438790563 -4.0020342366876155e-08 -0.09995591117469216 +2.7712000000000003 0.7070294560836216 0.7070282675080564 -3.908090644529809e-08 -0.09995592456510516 +2.7713 0.7070294798049859 0.7070282911197909 -3.814268183330999e-08 -0.09995593795145219 +2.7714000000000003 0.7070295035292237 0.7070283147142777 -3.720588462340947e-08 -0.09995595133373447 +2.7715 0.7070295272563194 0.7070283382915368 -3.6270730511493016e-08 -0.09995596471195327 +2.7716000000000003 0.7070295509862548 0.7070283618515906 -3.533743475148208e-08 -0.09995597808610976 +2.7717 0.7070295747190094 0.7070283853944641 -3.4406212101600886e-08 -0.09995599145620526 +2.7718000000000003 0.7070295984545603 0.7070284089201846 -3.347727677883994e-08 -0.09995600482224092 +2.7719 0.7070296221928827 0.7070284324287812 -3.255084240409538e-08 -0.09995601818421804 +2.772 0.7070296459339491 0.707028455920286 -3.1627121958909335e-08 -0.09995603154213786 +2.7721000000000005 0.7070296696777301 0.7070284793947326 -3.0706327732669264e-08 -0.09995604489600157 +2.7722 0.7070296934241934 0.7070285028521575 -2.9788671276637785e-08 -0.09995605824581039 +2.7723 0.7070297171733051 0.7070285262925986 -2.8874363352561494e-08 -0.09995607159156553 +2.7724 0.707029740925029 0.7070285497160974 -2.7963613887568156e-08 -0.09995608493326831 +2.7725 0.707029764679326 0.7070285731226964 -2.7056631921691318e-08 -0.09995609827091988 +2.7726 0.7070297884361557 0.7070285965124412 -2.6153625564719063e-08 -0.0999561116045215 +2.7727000000000004 0.7070298121954747 0.707028619885379 -2.5254801944585986e-08 -0.0999561249340744 +2.7728 0.7070298359572378 0.7070286432415596 -2.4360367161836705e-08 -0.09995613825957982 +2.7729 0.7070298597213973 0.707028666581035 -2.3470526242571482e-08 -0.099956151581039 +2.773 0.7070298834879035 0.7070286899038589 -2.2585483090090813e-08 -0.09995616489845309 +2.7731000000000003 0.7070299072567048 0.707028713210088 -2.1705440438057888e-08 -0.0999561782118234 +2.7732 0.7070299310277467 0.70702873649978 -2.0830599805395783e-08 -0.09995619152115111 +2.7733000000000003 0.7070299548009734 0.7070287597729961 -1.9961161452052012e-08 -0.09995620482643748 +2.7734 0.7070299785763264 0.7070287830297985 -1.9097324328691545e-08 -0.09995621812768371 +2.7735 0.7070300023537452 0.7070288062702523 -1.8239286033328722e-08 -0.09995623142489102 +2.7736000000000005 0.7070300261331677 0.7070288294944242 -1.7387242766658123e-08 -0.09995624471806068 +2.7737000000000003 0.7070300499145283 0.7070288527023834 -1.654138928738544e-08 -0.09995625800719382 +2.7738 0.7070300736977613 0.7070288758942008 -1.5701918864956255e-08 -0.09995627129229184 +2.7739000000000003 0.7070300974827974 0.7070288990699497 -1.4869023241825818e-08 -0.09995628457335584 +2.774 0.7070301212695658 0.7070289222297051 -1.4042892578815247e-08 -0.09995629785038707 +2.7741000000000002 0.7070301450579937 0.7070289453735443 -1.3223715423886506e-08 -0.09995631112338674 +2.7742000000000004 0.7070301688480061 0.7070289685015462 -1.2411678661835429e-08 -0.09995632439235605 +2.7743 0.7070301926395262 0.7070289916137922 -1.1606967473525714e-08 -0.09995633765729624 +2.7744 0.7070302164324749 0.7070290147103653 -1.080976529252084e-08 -0.09995635091820852 +2.7745 0.7070302402267723 0.7070290377913508 -1.0020253764751741e-08 -0.0999563641750942 +2.7746000000000004 0.7070302640223349 0.7070290608568356 -9.238612706449767e-09 -0.09995637742795441 +2.7747 0.7070302878190786 0.7070290839069087 -8.465020066850126e-09 -0.09995639067679046 +2.7748000000000004 0.7070303116169168 0.7070291069416608 -7.699651882221714e-09 -0.09995640392160347 +2.7749 0.7070303354157612 0.7070291299611848 -6.94268223466743e-09 -0.09995641716239478 +2.775 0.7070303592155214 0.7070291529655746 -6.194283217429708e-09 -0.09995643039916546 +2.7751000000000006 0.7070303830161053 0.707029175954927 -5.454624897593963e-09 -0.09995644363191682 +2.7752000000000003 0.7070304068174194 0.7070291989293401 -4.723875268383693e-09 -0.09995645686065008 +2.7753 0.7070304306193678 0.7070292218889138 -4.0022002222722675e-09 -0.0999564700853664 +2.7754000000000003 0.7070304544218532 0.70702924483375 -3.289763508482202e-09 -0.0999564833060671 +2.7755 0.7070304782247768 0.7070292677639514 -2.586726687882346e-09 -0.09995649652275332 +2.7756000000000003 0.7070305020280376 0.7070292906796238 -1.8932491113038408e-09 -0.0999565097354263 +2.7757 0.707030525831533 0.7070293135808741 -1.2094878709678625e-09 -0.0999565229440873 +2.7758000000000003 0.707030549635159 0.70702933646781 -5.355977709953219e-10 -0.09995653614873745 +2.7759 0.7070305734388096 0.7070293593405421 1.2826870988968953e-10 -0.09995654934937803 +2.776 0.7070305972423778 0.707029382199182 7.819614487175608e-10 -0.09995656254601026 +2.7761000000000005 0.7070306210457544 0.707029405043843 1.425332719039163e-09 -0.09995657573863534 +2.7762000000000002 0.7070306448488288 0.70702942787464 2.0582372160793394e-09 -0.09995658892725445 +2.7763 0.7070306686514891 0.707029450691689 2.6805320949008227e-09 -0.09995660211186887 +2.7764 0.7070306924536214 0.7070294734951083 3.2920770059660653e-09 -0.09995661529247973 +2.7765 0.7070307162551108 0.7070294962850169 3.892734118556007e-09 -0.0999566284690883 +2.7766 0.7070307400558413 0.707029519061536 4.4823681554645445e-09 -0.09995664164169585 +2.7767000000000004 0.7070307638556944 0.7070295418247876 5.060846425090915e-09 -0.09995665481030352 +2.7768 0.7070307876545513 0.7070295645748953 5.6280388526647185e-09 -0.0999566679749126 +2.7769 0.707030811452291 0.707029587311984 6.18381800019524e-09 -0.09995668113552422 +2.777 0.7070308352487913 0.7070296100361801 6.728059105502726e-09 -0.09995669429213963 +2.7771000000000003 0.7070308590439294 0.7070296327476111 7.260640110841321e-09 -0.09995670744476007 +2.7772 0.7070308828375802 0.7070296554464058 7.781441674174772e-09 -0.09995672059338664 +2.7773000000000003 0.707030906629618 0.7070296781326946 8.290347216881322e-09 -0.09995673373802066 +2.7774 0.7070309304199158 0.7070297008066084 8.787242935896777e-09 -0.09995674687866328 +2.7775 0.7070309542083455 0.7070297234682803 9.272017836674251e-09 -0.09995676001531578 +2.7776000000000005 0.7070309779947777 0.7070297461178439 9.744563750531399e-09 -0.09995677314797935 +2.7777000000000003 0.7070310017790817 0.7070297687554337 1.0204775366742802e-08 -0.09995678627665522 +2.7778 0.7070310255611258 0.7070297913811858 1.0652550250754567e-08 -0.09995679940134454 +2.7779000000000003 0.7070310493407774 0.7070298139952369 1.1087788865868364e-08 -0.09995681252204848 +2.778 0.707031073117903 0.7070298365977252 1.1510394603599094e-08 -0.09995682563876838 +2.7781000000000002 0.7070310968923674 0.7070298591887898 1.1920273792348501e-08 -0.09995683875150535 +2.7782000000000004 0.7070311206640352 0.7070298817685708 1.2317335734701729e-08 -0.09995685186026065 +2.7783 0.7070311444327696 0.7070299043372088 1.2701492706559958e-08 -0.09995686496503546 +2.7784 0.7070311681984334 0.7070299268948459 1.3072659994436964e-08 -0.09995687806583103 +2.7785 0.7070311919608878 0.7070299494416246 1.3430755906734815e-08 -0.09995689116264854 +2.7786000000000004 0.7070312157199937 0.7070299719776884 1.3775701793693196e-08 -0.09995690425548916 +2.7787 0.7070312394756112 0.7070299945031817 1.4107422060399832e-08 -0.09995691734435419 +2.7788000000000004 0.707031263227599 0.7070300170182495 1.4425844184137726e-08 -0.09995693042924471 +2.7789 0.7070312869758162 0.7070300395230378 1.4730898738671283e-08 -0.09995694351016203 +2.779 0.7070313107201198 0.707030062017693 1.5022519398583123e-08 -0.0999569565871073 +2.7791000000000006 0.7070313344603674 0.7070300845023625 1.5300642960958122e-08 -0.09995696966008176 +2.7792000000000003 0.7070313581964152 0.7070301069771938 1.556520935405703e-08 -0.09995698272908657 +2.7793 0.7070313819281187 0.7070301294423357 1.581616164599009e-08 -0.09995699579412295 +2.7794 0.7070314056553337 0.7070301518979374 1.6053446074207334e-08 -0.09995700885519218 +2.7795 0.7070314293779144 0.7070301743441483 1.627701203855969e-08 -0.09995702191229543 +2.7796000000000003 0.7070314530957151 0.7070301967811186 1.648681212298303e-08 -0.09995703496543384 +2.7797 0.7070314768085897 0.7070302192089986 1.668280209983497e-08 -0.09995704801460868 +2.7798000000000003 0.7070315005163912 0.7070302416279393 1.6864940944640028e-08 -0.0999570610598211 +2.7799 0.7070315242189726 0.7070302640380921 1.703319083782434e-08 -0.09995707410107234 +2.78 0.7070315479161863 0.707030286439609 1.718751716991984e-08 -0.09995708713836356 +2.7801000000000005 0.7070315716078848 0.707030308832642 1.732788856585038e-08 -0.09995710017169605 +2.7802000000000002 0.7070315952939192 0.7070303312173432 1.745427687018658e-08 -0.09995711320107088 +2.7803 0.7070316189741421 0.7070303535938655 1.7566657167095157e-08 -0.09995712622648939 +2.7804 0.7070316426484043 0.7070303759623617 1.766500777773683e-08 -0.0999571392479527 +2.7805 0.7070316663165569 0.7070303983229849 1.7749310268072582e-08 -0.09995715226546201 +2.7806 0.7070316899784512 0.7070304206758884 1.7819549450598382e-08 -0.09995716527901854 +2.7807000000000004 0.7070317136339379 0.7070304430212254 1.787571338868199e-08 -0.0999571782886235 +2.7808 0.7070317372828682 0.7070304653591495 1.791779339396088e-08 -0.09995719129427807 +2.7809 0.7070317609250923 0.7070304876898137 1.7945784030679035e-08 -0.09995720429598345 +2.781 0.7070317845604615 0.7070305100133718 1.7959683117421688e-08 -0.09995721729374084 +2.7811000000000003 0.7070318081888263 0.7070305323299777 1.7959491721911136e-08 -0.09995723028755146 +2.7812 0.7070318318100373 0.7070305546397839 1.7945214162741474e-08 -0.09995724327741644 +2.7813000000000003 0.7070318554239456 0.7070305769429448 1.7916858005909142e-08 -0.09995725626333707 +2.7814 0.7070318790304024 0.7070305992396128 1.7874434067415013e-08 -0.0999572692453145 +2.7815 0.7070319026292589 0.7070306215299416 1.7817956401121327e-08 -0.09995728222334999 +2.7816000000000005 0.7070319262203659 0.7070306438140834 1.774744230222114e-08 -0.09995729519744462 +2.7817000000000003 0.7070319498035754 0.7070306660921912 1.7662912297697342e-08 -0.09995730816759964 +2.7818 0.7070319733787392 0.7070306883644176 1.7564390141985853e-08 -0.09995732113381628 +2.7819000000000003 0.7070319969457095 0.7070307106309142 1.7451902809169362e-08 -0.09995733409609568 +2.782 0.7070320205043388 0.707030732891833 1.7325480489507883e-08 -0.09995734705443908 +2.7821000000000002 0.7070320440544797 0.7070307551473254 1.7185156580765137e-08 -0.0999573600088476 +2.7822000000000005 0.7070320675959857 0.7070307773975422 1.703096767086132e-08 -0.09995737295932254 +2.7823 0.7070320911287105 0.7070307996426344 1.686295354134254e-08 -0.09995738590586506 +2.7824 0.707032114652508 0.7070308218827515 1.668115715090096e-08 -0.0999573988484763 +2.7825 0.7070321381672329 0.7070308441180435 1.6485624619762274e-08 -0.0999574117871575 +2.7826000000000004 0.7070321616727404 0.7070308663486593 1.6276405232287794e-08 -0.09995742472190983 +2.7827 0.7070321851688863 0.7070308885747474 1.6053551410086242e-08 -0.09995743765273454 +2.7828000000000004 0.707032208655527 0.7070309107964559 1.5817118705942212e-08 -0.09995745057963276 +2.7829 0.7070322321325191 0.7070309330139315 1.55671657873363e-08 -0.09995746350260568 +2.783 0.7070322555997205 0.7070309552273214 1.5303754419965232e-08 -0.09995747642165453 +2.7831000000000006 0.7070322790569894 0.7070309774367709 1.50269494599356e-08 -0.0999574893367804 +2.7832000000000003 0.7070323025041851 0.7070309996424256 1.4736818836416643e-08 -0.09995750224798464 +2.7833 0.7070323259411675 0.7070310218444297 1.4433433528221462e-08 -0.09995751515526834 +2.7834 0.707032349367797 0.7070310440429268 1.4116867550796608e-08 -0.09995752805863273 +2.7835 0.7070323727839352 0.7070310662380597 1.3787197941476925e-08 -0.09995754095807902 +2.7836000000000003 0.7070323961894444 0.70703108842997 1.3444504735199425e-08 -0.09995755385360831 +2.7837 0.7070324195841877 0.707031110618799 1.3088870945421327e-08 -0.09995756674522185 +2.7838000000000003 0.7070324429680294 0.7070311328046863 1.2720382546772824e-08 -0.09995757963292079 +2.7839 0.7070324663408346 0.7070311549877715 1.2339128457709847e-08 -0.09995759251670638 +2.784 0.7070324897024693 0.7070311771681923 1.1945200511023768e-08 -0.09995760539657975 +2.7841000000000005 0.707032513052801 0.7070311993460862 1.1538693431289992e-08 -0.09995761827254215 +2.7842000000000002 0.7070325363916977 0.7070312215215887 1.1119704826194343e-08 -0.09995763114459474 +2.7843 0.7070325597190286 0.7070312436948349 1.0688335147501782e-08 -0.09995764401273866 +2.7844 0.7070325830346642 0.7070312658659589 1.0244687678913345e-08 -0.0999576568769752 +2.7845 0.7070326063384756 0.7070312880350931 9.788868493565417e-09 -0.09995766973730542 +2.7846 0.7070326296303361 0.7070313102023689 9.320986454029734e-09 -0.09995768259373058 +2.7847000000000004 0.7070326529101192 0.7070313323679166 8.841153165475846e-09 -0.09995769544625183 +2.7848 0.7070326761777004 0.7070313545318655 8.349482955721799e-09 -0.0999577082948704 +2.7849 0.7070326994329557 0.7070313766943431 7.846092852682729e-09 -0.09995772113958741 +2.785 0.7070327226757627 0.7070313988554762 7.331102552278479e-09 -0.09995773398040407 +2.7851000000000004 0.7070327459060008 0.7070314210153898 6.804634386341213e-09 -0.09995774681732163 +2.7852 0.7070327691235503 0.7070314431742081 6.26681329919665e-09 -0.0999577596503412 +2.7853000000000003 0.7070327923282931 0.7070314653320531 5.717766821643211e-09 -0.09995777247946407 +2.7854 0.707032815520112 0.707031487489046 5.157625028451296e-09 -0.09995778530469127 +2.7855 0.7070328386988913 0.7070315096453063 4.586520523618132e-09 -0.09995779812602403 +2.7856000000000005 0.7070328618645174 0.7070315318009524 4.004588390928154e-09 -0.09995781094346358 +2.7857000000000003 0.7070328850168777 0.707031553956101 3.4119661792078593e-09 -0.09995782375701104 +2.7858 0.7070329081558615 0.707031576110867 2.808793856355629e-09 -0.09995783656666767 +2.7859000000000003 0.7070329312813587 0.7070315982653641 2.1952137807187966e-09 -0.09995784937243456 +2.786 0.7070329543932616 0.7070316204197047 1.5713706716033449e-09 -0.0999578621743129 +2.7861000000000002 0.7070329774914643 0.7070316425739993 9.374115728447152e-10 -0.09995787497230399 +2.7862000000000005 0.7070330005758616 0.7070316647283563 2.9348581551125186e-10 -0.0999578877664089 +2.7863 0.7070330236463507 0.7070316868828836 -3.602550124534587e-10 -0.09995790055662884 +2.7864 0.7070330467028298 0.7070317090376863 -1.0236571069965894e-09 -0.09995791334296496 +2.7865 0.7070330697451996 0.7070317311928687 -1.6965644791810952e-09 -0.09995792612541848 +2.7866000000000004 0.7070330927733619 0.7070317533485326 -2.3788189985538e-09 -0.09995793890399057 +2.7867 0.70703311578722 0.7070317755047788 -3.070260421768334e-09 -0.09995795167868235 +2.7868000000000004 0.7070331387866797 0.707031797661706 -3.770726436820582e-09 -0.09995796444949509 +2.7869 0.7070331617716481 0.7070318198194112 -4.480052697743153e-09 -0.0999579772164299 +2.787 0.7070331847420341 0.7070318419779895 -5.198072867973469e-09 -0.099957989979488 +2.7871000000000006 0.7070332076977488 0.7070318641375346 -5.924618648976698e-09 -0.09995800273867059 +2.7872000000000003 0.7070332306387045 0.7070318862981378 -6.659519832287464e-09 -0.09995801549397879 +2.7873 0.7070332535648156 0.7070319084598886 -7.4026043298675015e-09 -0.09995802824541375 +2.7874 0.7070332764759985 0.7070319306228751 -8.153698219208472e-09 -0.0999580409929767 +2.7875 0.7070332993721715 0.7070319527871831 -8.912625782363237e-09 -0.0999580537366688 +2.7876000000000003 0.7070333222532548 0.7070319749528967 -9.679209548446588e-09 -0.09995806647649125 +2.7877 0.7070333451191704 0.707031997120098 -1.045327033266652e-08 -0.0999580792124452 +2.7878000000000003 0.7070333679698422 0.7070320192888672 -1.1234627279258641e-08 -0.09995809194453183 +2.7879 0.707033390805196 0.7070320414592821 -1.2023097904420577e-08 -0.09995810467275223 +2.788 0.7070334136251604 0.7070320636314193 -1.2818498138379014e-08 -0.09995811739710773 +2.7881000000000005 0.7070334364296648 0.7070320858053529 -1.3620642370926195e-08 -0.09995813011759941 +2.7882000000000002 0.7070334592186414 0.7070321079811552 -1.4429343488282786e-08 -0.09995814283422846 +2.7883 0.707033481992024 0.7070321301588962 -1.5244412921670142e-08 -0.09995815554699608 +2.7884 0.7070335047497487 0.707032152338644 -1.606566069371415e-08 -0.09995816825590337 +2.7885 0.7070335274917534 0.7070321745204646 -1.6892895454007073e-08 -0.09995818096095152 +2.7886 0.7070335502179788 0.7070321967044224 -1.7725924532450282e-08 -0.09995819366214177 +2.7887000000000004 0.7070335729283668 0.7070322188905789 -1.8564553977851866e-08 -0.09995820635947526 +2.7888 0.7070335956228615 0.7070322410789942 -1.940858860996833e-08 -0.09995821905295314 +2.7889 0.7070336183014094 0.7070322632697256 -2.0257832055066427e-08 -0.09995823174257656 +2.789 0.7070336409639597 0.707032285462829 -2.1112086805337438e-08 -0.09995824442834675 +2.7891000000000004 0.7070336636104624 0.7070323076583577 -2.197115424882115e-08 -0.09995825711026483 +2.7892 0.7070336862408708 0.7070323298563632 -2.2834834726218056e-08 -0.09995826978833205 +2.7893000000000003 0.7070337088551396 0.7070323520568942 -2.3702927574257432e-08 -0.09995828246254948 +2.7894 0.707033731453226 0.707032374259998 -2.457523117383592e-08 -0.09995829513291832 +2.7895 0.7070337540350895 0.7070323964657191 -2.5451542995554022e-08 -0.0999583077994397 +2.7896000000000005 0.7070337766006916 0.7070324186741003 -2.633165964438522e-08 -0.09995832046211486 +2.7897000000000003 0.707033799149996 0.7070324408851821 -2.7215376910416644e-08 -0.09995833312094496 +2.7898 0.7070338216829686 0.7070324630990024 -2.810248981568661e-08 -0.09995834577593109 +2.7899000000000003 0.7070338441995776 0.7070324853155973 -2.8992792660588462e-08 -0.09995835842707451 +2.79 0.7070338666997933 0.7070325075350007 -2.988607907135864e-08 -0.09995837107437634 +2.7901000000000002 0.7070338891835883 0.7070325297572442 -3.07821420501668e-08 -0.09995838371783777 +2.7902000000000005 0.7070339116509374 0.7070325519823568 -3.168077401848393e-08 -0.09995839635745996 +2.7903000000000002 0.7070339341018179 0.7070325742103658 -3.258176687064192e-08 -0.09995840899324404 +2.7904 0.7070339565362092 0.7070325964412958 -3.3484912016984794e-08 -0.09995842162519124 +2.7905 0.707033978954092 0.7070326186751694 -3.4390000437645174e-08 -0.09995843425330261 +2.7906000000000004 0.7070340013554508 0.7070326409120071 -3.529682272656286e-08 -0.09995844687757943 +2.7907 0.7070340237402715 0.7070326631518269 -3.6205169139948666e-08 -0.09995845949802279 +2.7908000000000004 0.707034046108542 0.7070326853946445 -3.711482964745879e-08 -0.09995847211463385 +2.7909 0.7070340684602536 0.7070327076404738 -3.8025593978490216e-08 -0.09995848472741388 +2.791 0.7070340907953989 0.707032729889326 -3.893725167162035e-08 -0.09995849733636399 +2.7911000000000006 0.7070341131139727 0.7070327521412099 -3.984959212372137e-08 -0.09995850994148531 +2.7912000000000003 0.7070341354159725 0.7070327743961322 -4.076240463723145e-08 -0.09995852254277901 +2.7913 0.7070341577013977 0.7070327966540979 -4.1675478470732785e-08 -0.09995853514024626 +2.7914 0.7070341799702502 0.707032818915109 -4.258860288470492e-08 -0.09995854773388824 +2.7915 0.7070342022225344 0.7070328411791653 -4.35015671930989e-08 -0.09995856032370604 +2.7916000000000003 0.7070342244582564 0.7070328634462646 -4.441416081149617e-08 -0.0999585729097009 +2.7917 0.707034246677425 0.7070328857164025 -4.532617330307875e-08 -0.09995858549187392 +2.7918000000000003 0.7070342688800512 0.707032907989572 -4.623739443046764e-08 -0.0999585980702263 +2.7919 0.7070342910661481 0.7070329302657644 -4.714761420122546e-08 -0.09995861064475926 +2.792 0.7070343132357312 0.7070329525449679 -4.8056622917831346e-08 -0.09995862321547387 +2.7921000000000005 0.707034335388818 0.7070329748271691 -4.8964211227784694e-08 -0.0999586357823713 +2.7922000000000002 0.7070343575254283 0.7070329971123523 -4.987017016813873e-08 -0.09995864834545272 +2.7923 0.7070343796455845 0.7070330194004995 -5.077429121569908e-08 -0.09995866090471926 +2.7924 0.7070344017493106 0.7070330416915902 -5.1676366333427634e-08 -0.09995867346017212 +2.7925 0.7070344238366337 0.7070330639856018 -5.257618802107476e-08 -0.09995868601181243 +2.7926 0.7070344459075824 0.70703308628251 -5.347354935995689e-08 -0.09995869855964139 +2.7927000000000004 0.7070344679621877 0.7070331085822876 -5.4368244063046633e-08 -0.0999587111036601 +2.7928 0.7070344900004829 0.7070331308849052 -5.526006651964191e-08 -0.0999587236438697 +2.7929 0.7070345120225037 0.707033153190332 -5.614881184415506e-08 -0.09995873618027148 +2.793 0.7070345340282871 0.7070331754985342 -5.703427592490193e-08 -0.09995874871286649 +2.7931000000000004 0.7070345560178734 0.7070331978094762 -5.7916255467903646e-08 -0.0999587612416559 +2.7932 0.7070345779913045 0.7070332201231198 -5.8794548046326237e-08 -0.09995877376664089 +2.7933000000000003 0.7070345999486246 0.7070332424394249 -5.966895214254767e-08 -0.09995878628782255 +2.7934 0.7070346218898799 0.7070332647583495 -6.05392671978143e-08 -0.09995879880520207 +2.7935 0.7070346438151187 0.707033287079849 -6.140529366059633e-08 -0.0999588113187806 +2.7936000000000005 0.707034665724392 0.7070333094038773 -6.226683302648639e-08 -0.09995882382855933 +2.7937000000000003 0.7070346876177522 0.7070333317303854 -6.312368788612133e-08 -0.09995883633453939 +2.7938 0.7070347094952543 0.7070333540593228 -6.397566197158602e-08 -0.09995884883672194 +2.7939000000000003 0.7070347313569549 0.7070333763906368 -6.482256020455199e-08 -0.09995886133510813 +2.794 0.7070347532029131 0.7070333987242721 -6.56641887292371e-08 -0.09995887382969908 +2.7941000000000003 0.7070347750331902 0.7070334210601721 -6.650035497095252e-08 -0.09995888632049602 +2.7942000000000005 0.7070347968478489 0.7070334433982775 -6.73308676703635e-08 -0.09995889880749996 +2.7943000000000002 0.7070348186469544 0.7070334657385273 -6.815553693162793e-08 -0.09995891129071219 +2.7944 0.707034840430574 0.7070334880808586 -6.897417426576444e-08 -0.09995892377013377 +2.7945 0.7070348621987768 0.7070335104252061 -6.978659262968367e-08 -0.0999589362457659 +2.7946000000000004 0.7070348839516339 0.7070335327715029 -7.05926064738932e-08 -0.09995894871760974 +2.7947 0.7070349056892182 0.7070335551196798 -7.139203178239614e-08 -0.09995896118566638 +2.7948000000000004 0.7070349274116056 0.707033577469666 -7.218468611389084e-08 -0.09995897364993707 +2.7949 0.7070349491188723 0.7070335998213885 -7.297038864687369e-08 -0.09995898611042292 +2.795 0.7070349708110977 0.7070336221747722 -7.374896021823674e-08 -0.09995899856712501 +2.7951000000000006 0.7070349924883621 0.7070336445297405 -7.452022336403366e-08 -0.09995901102004455 +2.7952000000000004 0.7070350141507485 0.7070336668862146 -7.528400235894475e-08 -0.09995902346918263 +2.7953 0.7070350357983418 0.7070336892441142 -7.604012325964499e-08 -0.09995903591454053 +2.7954 0.7070350574312281 0.7070337116033567 -7.678841393993219e-08 -0.09995904835611923 +2.7955 0.7070350790494955 0.7070337339638579 -7.752870413452878e-08 -0.09995906079391995 +2.7956000000000003 0.7070351006532345 0.7070337563255322 -7.826082547898044e-08 -0.09995907322794391 +2.7957 0.7070351222425366 0.7070337786882911 -7.898461153611064e-08 -0.09995908565819211 +2.7958000000000003 0.7070351438174958 0.7070338010520456 -7.969989784719494e-08 -0.09995909808466583 +2.7959 0.7070351653782072 0.7070338234167043 -8.040652196492082e-08 -0.09995911050736617 +2.796 0.7070351869247676 0.7070338457821741 -8.11043234915515e-08 -0.09995912292629423 +2.7961000000000005 0.7070352084572762 0.7070338681483603 -8.179314410754895e-08 -0.09995913534145122 +2.7962000000000002 0.7070352299758333 0.7070338905151665 -8.247282761754404e-08 -0.09995914775283826 +2.7963 0.7070352514805409 0.7070339128824947 -8.314321998156154e-08 -0.09995916016045649 +2.7964 0.707035272971503 0.7070339352502453 -8.380416934971463e-08 -0.09995917256430706 +2.7965 0.7070352944488244 0.7070339576183167 -8.445552609429724e-08 -0.09995918496439107 +2.7966 0.7070353159126124 0.7070339799866063 -8.509714285055009e-08 -0.09995919736070973 +2.7967000000000004 0.7070353373629752 0.7070340023550097 -8.57288745452836e-08 -0.09995920975326411 +2.7968 0.7070353588000231 0.707034024723421 -8.63505784246335e-08 -0.09995922214205544 +2.7969 0.7070353802238675 0.7070340470917327 -8.696211409395943e-08 -0.09995923452708483 +2.797 0.7070354016346214 0.7070340694598357 -8.756334354906997e-08 -0.09995924690835344 +2.7971000000000004 0.7070354230323992 0.7070340918276199 -8.815413120571297e-08 -0.09995925928586238 +2.7972 0.7070354444173166 0.7070341141949734 -8.873434392906582e-08 -0.09995927165961281 +2.7973000000000003 0.7070354657894908 0.7070341365617832 -8.930385106409311e-08 -0.09995928402960585 +2.7974 0.7070354871490404 0.7070341589279341 -8.986252446503695e-08 -0.09995929639584261 +2.7975 0.7070355084960853 0.7070341812933106 -9.041023852490726e-08 -0.09995930875832426 +2.7976000000000005 0.7070355298307471 0.7070342036577955 -9.094687020236997e-08 -0.09995932111705196 +2.7977000000000003 0.7070355511531482 0.7070342260212699 -9.147229905470677e-08 -0.09995933347202679 +2.7978 0.7070355724634125 0.7070342483836145 -9.19864072525603e-08 -0.09995934582324999 +2.7979000000000003 0.707035593761665 0.707034270744708 -9.248907961723063e-08 -0.09995935817072266 +2.798 0.707035615048032 0.7070342931044284 -9.29802036484309e-08 -0.09995937051444592 +2.7981000000000003 0.7070356363226409 0.707034315462652 -9.345966954076718e-08 -0.0999593828544209 +2.7982000000000005 0.7070356575856199 0.7070343378192544 -9.392737020802455e-08 -0.09995939519064873 +2.7983000000000002 0.7070356788370993 0.70703436017411 -9.438320131786165e-08 -0.0999594075231306 +2.7984 0.7070357000772096 0.7070343825270918 -9.482706130568841e-08 -0.09995941985186758 +2.7985 0.7070357213060825 0.7070344048780721 -9.525885139895218e-08 -0.09995943217686083 +2.7986000000000004 0.707035742523851 0.7070344272269221 -9.567847563708709e-08 -0.0999594444981115 +2.7987 0.7070357637306488 0.7070344495735119 -9.608584089926958e-08 -0.09995945681562068 +2.7988000000000004 0.7070357849266111 0.7070344719177108 -9.648085691829622e-08 -0.09995946912938959 +2.7989 0.7070358061118733 0.7070344942593871 -9.686343630486982e-08 -0.09995948143941936 +2.799 0.7070358272865722 0.7070345165984082 -9.723349457101821e-08 -0.09995949374571106 +2.7991 0.7070358484508454 0.7070345389346404 -9.759095013529839e-08 -0.09995950604826585 +2.7992000000000004 0.7070358696048311 0.7070345612679494 -9.793572435055214e-08 -0.09995951834708489 +2.7993 0.7070358907486687 0.7070345835982002 -9.82677415195185e-08 -0.09995953064216928 +2.7994 0.7070359118824977 0.7070346059252564 -9.858692891218102e-08 -0.09995954293352013 +2.7995 0.7070359330064591 0.7070346282489817 -9.889321678484969e-08 -0.09995955522113859 +2.7996000000000003 0.7070359541206941 0.7070346505692386 -9.918653838102837e-08 -0.09995956750502581 +2.7997 0.707035975225345 0.7070346728858892 -9.946682996263972e-08 -0.09995957978518293 +2.7998000000000003 0.7070359963205546 0.7070346951987947 -9.973403081783155e-08 -0.09995959206161109 +2.7999 0.7070360174064663 0.7070347175078155 -9.998808326791564e-08 -0.09995960433431143 +2.8 0.7070360384832237 0.7070347398128123 -1.0022893269252126e-07 -0.09995961660328509 +2.8001000000000005 0.7070360595509715 0.7070347621136441 -1.0045652753046252e-07 -0.09995962886853314 +2.8002000000000002 0.7070360806098545 0.7070347844101698 -1.0067081929188149e-07 -0.09995964113005672 +2.8003 0.7070361016600184 0.7070348067022483 -1.0087176257646269e-07 -0.09995965338785698 +2.8004000000000002 0.7070361227016089 0.7070348289897374 -1.010593150708311e-07 -0.09995966564193506 +2.8005 0.7070361437347723 0.7070348512724947 -1.0123343756763409e-07 -0.09995967789229201 +2.8006 0.7070361647596555 0.707034873550378 -1.0139409397248028e-07 -0.0999596901389291 +2.8007000000000004 0.7070361857764051 0.7070348958232436 -1.0154125130220487e-07 -0.09995970238184734 +2.8008 0.7070362067851694 0.7070349180909486 -1.0167487970221684e-07 -0.09995971462104794 +2.8009 0.7070362277860953 0.7070349403533494 -1.0179495244996839e-07 -0.09995972685653202 +2.801 0.7070362487793311 0.7070349626103016 -1.0190144595322026e-07 -0.09995973908830065 +2.8011000000000004 0.7070362697650248 0.7070349848616614 -1.0199433976652156e-07 -0.09995975131635501 +2.8012 0.7070362907433244 0.7070350071072844 -1.0207361658427089e-07 -0.0999597635406962 +2.8013000000000003 0.7070363117143788 0.707035029347026 -1.0213926224678788e-07 -0.09995977576132536 +2.8014 0.7070363326783361 0.707035051580742 -1.021912657420479e-07 -0.09995978797824359 +2.8015 0.7070363536353453 0.7070350738082873 -1.0222961921609042e-07 -0.09995980019145206 +2.8016000000000005 0.707036374585555 0.7070350960295176 -1.0225431796434536e-07 -0.09995981240095189 +2.8017000000000003 0.7070363955291137 0.707035118244288 -1.0226536042729634e-07 -0.09995982460674416 +2.8018 0.7070364164661702 0.707035140452454 -1.0226274820262365e-07 -0.09995983680883005 +2.8019000000000003 0.7070364373968734 0.7070351626538707 -1.0224648603739811e-07 -0.09995984900721068 +2.802 0.7070364583213715 0.7070351848483937 -1.0221658182374416e-07 -0.09995986120188716 +2.8021000000000003 0.7070364792398129 0.7070352070358785 -1.021730466057788e-07 -0.09995987339286061 +2.8022000000000005 0.707036500152346 0.7070352292161808 -1.0211589456052966e-07 -0.09995988558013214 +2.8023000000000002 0.7070365210591185 0.7070352513891565 -1.020451430031391e-07 -0.09995989776370286 +2.8024 0.7070365419602788 0.707035273554662 -1.0196081239120108e-07 -0.09995990994357397 +2.8025 0.7070365628559737 0.7070352957125534 -1.0186292629613819e-07 -0.0999599221197465 +2.8026000000000004 0.707036583746351 0.7070353178626878 -1.0175151141881417e-07 -0.09995993429222161 +2.8027 0.7070366046315575 0.7070353400049217 -1.0162659756871723e-07 -0.09995994646100043 +2.8028000000000004 0.70703662551174 0.707035362139113 -1.014882176604906e-07 -0.09995995862608412 +2.8029 0.7070366463870444 0.7070353842651194 -1.0133640770699365e-07 -0.09995997078747376 +2.803 0.7070366672576167 0.7070354063827986 -1.0117120681236297e-07 -0.09995998294517047 +2.8031 0.707036688123602 0.70703542849201 -1.0099265715466516e-07 -0.09995999509917541 +2.8032000000000004 0.707036708985145 0.7070354505926122 -1.008008039746211e-07 -0.09996000724948961 +2.8033 0.7070367298423903 0.707035472684465 -1.0059569557300391e-07 -0.09996001939611429 +2.8034 0.7070367506954816 0.7070354947674287 -1.0037738329936319e-07 -0.09996003153905052 +2.8035 0.7070367715445618 0.7070355168413639 -1.0014592152340213e-07 -0.09996004367829936 +2.8036000000000003 0.7070367923897735 0.7070355389061325 -9.990136764451846e-08 -0.09996005581386205 +2.8037 0.7070368132312587 0.707035560961596 -9.964378205277319e-08 -0.09996006794573963 +2.8038000000000003 0.7070368340691585 0.7070355830076176 -9.93732281358295e-08 -0.09996008007393323 +2.8039 0.7070368549036135 0.7070356050440609 -9.908977224252352e-08 -0.09996009219844405 +2.804 0.7070368757347631 0.7070356270707898 -9.879348368980329e-08 -0.09996010431927309 +2.8041000000000005 0.7070368965627466 0.7070356490876697 -9.848443473410573e-08 -0.09996011643642155 +2.8042000000000002 0.7070369173877018 0.707035671094566 -9.816270054967269e-08 -0.0999601285498905 +2.8043 0.7070369382097661 0.7070356930913456 -9.782835921380573e-08 -0.09996014065968106 +2.8044000000000002 0.7070369590290758 0.7070357150778761 -9.748149168951892e-08 -0.09996015276579438 +2.8045 0.7070369798457665 0.7070357370540258 -9.712218180472215e-08 -0.09996016486823152 +2.8046 0.7070370006599727 0.7070357590196643 -9.675051623921072e-08 -0.09996017696699365 +2.8047000000000004 0.707037021471828 0.7070357809746617 -9.636658448910346e-08 -0.09996018906208184 +2.8048 0.7070370422814649 0.7070358029188892 -9.597047885556709e-08 -0.09996020115349719 +2.8049 0.7070370630890153 0.7070358248522199 -9.556229442053005e-08 -0.09996021324124094 +2.805 0.7070370838946094 0.7070358467745268 -9.51421290241311e-08 -0.09996022532531408 +2.8051000000000004 0.707037104698377 0.7070358686856844 -9.471008324043323e-08 -0.0999602374057178 +2.8052 0.707037125500446 0.707035890585568 -9.426626035834162e-08 -0.09996024948245313 +2.8053000000000003 0.7070371463009433 0.7070359124740548 -9.381076634864399e-08 -0.09996026155552123 +2.8054 0.7070371670999955 0.707035934351023 -9.334370984406121e-08 -0.09996027362492325 +2.8055 0.7070371878977271 0.7070359562163512 -9.286520210802229e-08 -0.09996028569066022 +2.8056000000000005 0.7070372086942617 0.7070359780699201 -9.237535701644983e-08 -0.09996029775273335 +2.8057000000000003 0.7070372294897215 0.7070359999116111 -9.18742910274023e-08 -0.09996030981114364 +2.8058 0.7070372502842277 0.7070360217413073 -9.136212314637959e-08 -0.09996032186589228 +2.8059000000000003 0.7070372710779003 0.7070360435588929 -9.083897490984316e-08 -0.0999603339169804 +2.806 0.707037291870857 0.7070360653642535 -9.030497035052154e-08 -0.0999603459644091 +2.8061000000000003 0.7070373126632152 0.707036087157276 -8.976023596531796e-08 -0.09996035800817947 +2.8062000000000005 0.7070373334550906 0.7070361089378485 -8.920490069015685e-08 -0.09996037004829257 +2.8063000000000002 0.7070373542465969 0.7070361307058608 -8.86390958696262e-08 -0.09996038208474955 +2.8064 0.7070373750378474 0.7070361524612043 -8.806295521707891e-08 -0.09996039411755153 +2.8065 0.7070373958289532 0.7070361742037712 -8.747661479728552e-08 -0.09996040614669961 +2.8066000000000004 0.7070374166200242 0.707036195933456 -8.688021298480092e-08 -0.09996041817219496 +2.8067 0.7070374374111686 0.7070362176501541 -8.627389043100453e-08 -0.09996043019403861 +2.8068 0.7070374582024932 0.7070362393537628 -8.565779003461005e-08 -0.09996044221223166 +2.8069 0.7070374789941033 0.7070362610441807 -8.503205690957305e-08 -0.0999604542267753 +2.807 0.7070374997861024 0.7070362827213084 -8.439683834519235e-08 -0.09996046623767059 +2.8071 0.7070375205785924 0.7070363043850472 -8.375228377488497e-08 -0.09996047824491855 +2.8072000000000004 0.7070375413716736 0.7070363260353014 -8.30985447458285e-08 -0.09996049024852047 +2.8073 0.707037562165445 0.7070363476719758 -8.243577487038883e-08 -0.0999605022484773 +2.8074 0.7070375829600034 0.7070363692949774 -8.176412980356873e-08 -0.09996051424479024 +2.8075 0.7070376037554442 0.7070363909042146 -8.108376719443561e-08 -0.09996052623746035 +2.8076000000000003 0.707037624551861 0.7070364124995976 -8.039484666357011e-08 -0.0999605382264887 +2.8077 0.7070376453493459 0.7070364340810389 -7.969752975189176e-08 -0.0999605502118765 +2.8078000000000003 0.7070376661479885 0.7070364556484519 -7.899197989290341e-08 -0.09996056219362477 +2.8079 0.7070376869478776 0.7070364772017526 -7.827836236498631e-08 -0.09996057417173465 +2.808 0.7070377077490997 0.7070364987408579 -7.755684426104248e-08 -0.09996058614620729 +2.8081000000000005 0.7070377285517394 0.7070365202656872 -7.682759444339188e-08 -0.09996059811704366 +2.8082000000000003 0.7070377493558797 0.7070365417761617 -7.609078351254739e-08 -0.09996061008424506 +2.8083 0.7070377701616015 0.707036563272204 -7.534658375430575e-08 -0.0999606220478124 +2.8084000000000002 0.7070377909689838 0.7070365847537388 -7.459516911459407e-08 -0.09996063400774687 +2.8085 0.7070378117781043 0.7070366062206928 -7.383671514482604e-08 -0.0999606459640496 +2.8086 0.7070378325890379 0.7070366276729942 -7.307139896894216e-08 -0.09996065791672158 +2.8087000000000004 0.7070378534018585 0.7070366491105743 -7.229939924394482e-08 -0.09996066986576406 +2.8088 0.7070378742166374 0.7070366705333646 -7.152089610872395e-08 -0.09996068181117802 +2.8089 0.7070378950334439 0.7070366919413 -7.073607115239827e-08 -0.09996069375296458 +2.809 0.7070379158523459 0.7070367133343167 -6.994510736444207e-08 -0.09996070569112492 +2.8091000000000004 0.7070379366734088 0.707036734712353 -6.914818909825593e-08 -0.09996071762566008 +2.8092 0.7070379574966965 0.7070367560753494 -6.834550202389558e-08 -0.09996072955657123 +2.8093000000000004 0.7070379783222702 0.7070367774232478 -6.753723308687218e-08 -0.09996074148385939 +2.8094 0.7070379991501898 0.7070367987559926 -6.672357046044741e-08 -0.09996075340752567 +2.8095 0.7070380199805129 0.7070368200735302 -6.590470350920433e-08 -0.09996076532757117 +2.8096000000000005 0.7070380408132945 0.7070368413758088 -6.508082273830665e-08 -0.09996077724399699 +2.8097000000000003 0.7070380616485883 0.7070368626627794 -6.425211975403383e-08 -0.09996078915680427 +2.8098 0.7070380824864455 0.7070368839343943 -6.341878721781088e-08 -0.09996080106599407 +2.8099000000000003 0.7070381033269155 0.7070369051906078 -6.258101879503403e-08 -0.09996081297156743 +2.81 0.7070381241700459 0.707036926431377 -6.17390091208099e-08 -0.09996082487352564 +2.8101000000000003 0.7070381450158811 0.7070369476566607 -6.089295374921491e-08 -0.09996083677186964 +2.8102000000000005 0.7070381658644644 0.7070369688664198 -6.00430491086261e-08 -0.09996084866660054 +2.8103000000000002 0.7070381867158365 0.707036990060617 -5.918949245358254e-08 -0.09996086055771947 +2.8104 0.7070382075700361 0.7070370112392179 -5.833248182358572e-08 -0.0999608724452275 +2.8105 0.7070382284271 0.7070370324021895 -5.747221599300932e-08 -0.09996088432912575 +2.8106000000000004 0.7070382492870623 0.7070370535495014 -5.660889443076696e-08 -0.0999608962094153 +2.8107 0.7070382701499552 0.7070370746811251 -5.574271724610204e-08 -0.0999609080860972 +2.8108 0.7070382910158093 0.7070370957970344 -5.487388514803862e-08 -0.09996091995917264 +2.8109 0.7070383118846522 0.7070371168972054 -5.400259939745966e-08 -0.09996093182864264 +2.811 0.70703833275651 0.7070371379816162 -5.312906175983581e-08 -0.09996094369450839 +2.8111 0.7070383536314058 0.7070371590502468 -5.225347445882156e-08 -0.0999609555567709 +2.8112000000000004 0.7070383745093615 0.7070371801030797 -5.137604013006822e-08 -0.09996096741543128 +2.8113 0.7070383953903963 0.7070372011400995 -5.0496961773952714e-08 -0.09996097927049065 +2.8114 0.7070384162745271 0.7070372221612928 -4.961644270863163e-08 -0.09996099112195003 +2.8115 0.7070384371617686 0.7070372431666492 -4.8734686522878407e-08 -0.09996100296981057 +2.8116000000000003 0.7070384580521337 0.7070372641561593 -4.7851897028161616e-08 -0.09996101481407332 +2.8117 0.7070384789456329 0.7070372851298168 -4.6968278213542144e-08 -0.09996102665473944 +2.8118000000000003 0.7070384998422745 0.707037306087617 -4.6084034197046726e-08 -0.09996103849181 +2.8119 0.7070385207420649 0.7070373270295579 -4.519936918018566e-08 -0.09996105032528607 +2.812 0.7070385416450072 0.7070373479556391 -4.431448739845899e-08 -0.0999610621551687 +2.8121000000000005 0.707038562551104 0.7070373688658632 -4.342959307469514e-08 -0.09996107398145909 +2.8122000000000003 0.7070385834603543 0.7070373897602344 -4.2544890374676567e-08 -0.09996108580415826 +2.8123 0.7070386043727559 0.7070374106387591 -4.1660583356931016e-08 -0.09996109762326737 +2.8124000000000002 0.7070386252883034 0.7070374315014463 -4.077687592712051e-08 -0.09996110943878742 +2.8125 0.70703864620699 0.7070374523483064 -3.989397179032968e-08 -0.09996112125071951 +2.8126 0.7070386671288065 0.707037473179353 -3.901207440307284e-08 -0.09996113305906479 +2.8127000000000004 0.7070386880537414 0.7070374939946006 -3.813138693133881e-08 -0.09996114486382424 +2.8128 0.7070387089817808 0.7070375147940673 -3.725211219867113e-08 -0.099961156664999 +2.8129 0.7070387299129095 0.7070375355777727 -3.637445263916794e-08 -0.09996116846259022 +2.813 0.7070387508471092 0.7070375563457383 -3.5498610255848585e-08 -0.09996118025659889 +2.8131000000000004 0.7070387717843601 0.7070375770979882 -3.462478656980454e-08 -0.0999611920470262 +2.8132 0.7070387927246399 0.7070375978345488 -3.3753182574446094e-08 -0.09996120383387322 +2.8133000000000004 0.7070388136679238 0.7070376185554478 -3.288399869202582e-08 -0.09996121561714094 +2.8134 0.7070388346141856 0.707037639260716 -3.20174347243074e-08 -0.09996122739683057 +2.8135 0.7070388555633966 0.7070376599503859 -3.115368980865542e-08 -0.09996123917294314 +2.8136000000000005 0.7070388765155257 0.707037680624492 -3.029296237076415e-08 -0.0999612509454797 +2.8137000000000003 0.7070388974705399 0.7070377012830712 -2.9435450080205275e-08 -0.09996126271444133 +2.8138 0.7070389184284045 0.7070377219261621 -2.8581349804457715e-08 -0.09996127447982917 +2.8139000000000003 0.7070389393890824 0.7070377425538064 -2.773085756510585e-08 -0.09996128624164431 +2.814 0.7070389603525338 0.7070377631660464 -2.688416849186935e-08 -0.09996129799988779 +2.8141000000000003 0.7070389813187177 0.7070377837629276 -2.6041476776633016e-08 -0.09996130975456069 +2.8142000000000005 0.7070390022875908 0.7070378043444977 -2.5202975631813396e-08 -0.09996132150566418 +2.8143000000000002 0.7070390232591074 0.7070378249108055 -2.4368857242003383e-08 -0.09996133325319928 +2.8144 0.70703904423322 0.7070378454619026 -2.3539312725157774e-08 -0.09996134499716708 +2.8145 0.7070390652098791 0.7070378659978422 -2.2714532081202082e-08 -0.09996135673756867 +2.8146000000000004 0.7070390861890328 0.70703788651868 -2.1894704158639117e-08 -0.09996136847440507 +2.8147 0.707039107170628 0.7070379070244734 -2.1080016602507273e-08 -0.09996138020767747 +2.8148 0.7070391281546085 0.7070379275152816 -2.0270655818818706e-08 -0.09996139193738686 +2.8149 0.7070391491409168 0.7070379479911664 -1.946680692251762e-08 -0.09996140366353436 +2.815 0.7070391701294936 0.7070379684521908 -1.8668653704954213e-08 -0.09996141538612105 +2.8151 0.7070391911202772 0.7070379888984205 -1.7876378587480812e-08 -0.09996142710514799 +2.8152000000000004 0.7070392121132043 0.7070380093299227 -1.7090162578083795e-08 -0.09996143882061634 +2.8153 0.7070392331082093 0.7070380297467667 -1.631018523365335e-08 -0.09996145053252709 +2.8154 0.7070392541052248 0.7070380501490233 -1.5536624614446992e-08 -0.09996146224088132 +2.8155 0.7070392751041819 0.707038070536766 -1.4769657248094037e-08 -0.09996147394568018 +2.8156000000000003 0.7070392961050089 0.7070380909100695 -1.400945808709489e-08 -0.0999614856469247 +2.8157 0.7070393171076337 0.7070381112690105 -1.3256200471090801e-08 -0.09996149734461598 +2.8158000000000003 0.7070393381119808 0.7070381316136678 -1.2510056082628424e-08 -0.09996150903875509 +2.8159 0.7070393591179738 0.7070381519441216 -1.1771194912031657e-08 -0.09996152072934306 +2.816 0.7070393801255344 0.7070381722604544 -1.1039785219237735e-08 -0.09996153241638106 +2.8161000000000005 0.7070394011345823 0.7070381925627498 -1.0315993492597542e-08 -0.0999615440998701 +2.8162000000000003 0.7070394221450353 0.7070382128510938 -9.599984413313778e-09 -0.0999615557798112 +2.8163 0.7070394431568101 0.7070382331255742 -8.891920814241283e-09 -0.09996156745620559 +2.8164000000000002 0.707039464169821 0.7070382533862801 -8.191963651697776e-09 -0.09996157912905428 +2.8165 0.7070394851839812 0.7070382736333025 -7.500271955590554e-09 -0.09996159079835835 +2.8166 0.7070395061992014 0.7070382938667339 -6.8170028025282825e-09 -0.09996160246411888 +2.8167000000000004 0.7070395272153911 0.7070383140866687 -6.142311284595969e-09 -0.09996161412633689 +2.8168 0.7070395482324585 0.707038334293203 -5.476350459047985e-09 -0.09996162578501355 +2.8169 0.7070395692503095 0.7070383544864338 -4.8192713266240195e-09 -0.09996163744014984 +2.817 0.7070395902688489 0.7070383746664608 -4.171222793385165e-09 -0.09996164909174686 +2.8171000000000004 0.7070396112879798 0.7070383948333845 -3.5323516334173632e-09 -0.09996166073980568 +2.8172 0.7070396323076036 0.7070384149873071 -2.9028024645452732e-09 -0.0999616723843274 +2.8173000000000004 0.7070396533276204 0.7070384351283328 -2.2827177058315495e-09 -0.09996168402531312 +2.8174 0.7070396743479288 0.7070384552565667 -1.6722375506886267e-09 -0.0999616956627639 +2.8175 0.7070396953684255 0.7070384753721155 -1.0714999339189735e-09 -0.09996170729668075 +2.8176000000000005 0.7070397163890063 0.7070384954750875 -4.806404978879852e-10 -0.09996171892706482 +2.8177000000000003 0.7070397374095652 0.7070385155655923 1.0020742829269791e-10 -0.0999617305539171 +2.8178 0.707039758429995 0.7070385356437411 6.70912872133278e-10 -0.09996174217723876 +2.8179000000000003 0.7070397794501868 0.7070385557096464 1.231347241184566e-09 -0.0999617537970308 +2.818 0.7070398004700309 0.7070385757634216 1.7813843490588344e-09 -0.0999617654132943 +2.8181000000000003 0.7070398214894159 0.7070385958051821 2.32090044231803e-09 -0.09996177702603032 +2.8182000000000005 0.7070398425082292 0.7070386158350445 2.8497742421071393e-09 -0.09996178863523998 +2.8183000000000002 0.7070398635263564 0.7070386358531262 3.3678869545625267e-09 -0.0999618002409243 +2.8184 0.7070398845436832 0.7070386558595463 3.87512230724113e-09 -0.09996181184308442 +2.8185 0.7070399055600927 0.7070386758544253 4.3713665673350555e-09 -0.09996182344172139 +2.8186000000000004 0.7070399265754674 0.7070386958378838 4.856508585039665e-09 -0.09996183503683621 +2.8187 0.7070399475896888 0.7070387158100447 5.330439793553576e-09 -0.09996184662843004 +2.8188 0.7070399686026367 0.7070387357710315 5.793054250712026e-09 -0.09996185821650386 +2.8189 0.7070399896141903 0.7070387557209692 6.244248657201468e-09 -0.09996186980105881 +2.819 0.7070400106242278 0.7070387756599834 6.683922379110974e-09 -0.09996188138209594 +2.8191 0.7070400316326255 0.7070387955882009 7.111977469616282e-09 -0.09996189295961627 +2.8192000000000004 0.70704005263926 0.7070388155057499 7.528318700204817e-09 -0.09996190453362093 +2.8193 0.7070400736440055 0.7070388354127588 7.932853558073605e-09 -0.09996191610411091 +2.8194 0.7070400946467363 0.7070388553093578 8.325492296436254e-09 -0.09996192767108732 +2.8195 0.7070401156473258 0.7070388751956775 8.70614793625768e-09 -0.09996193923455131 +2.8196000000000003 0.7070401366456456 0.7070388950718498 9.074736286203422e-09 -0.09996195079450382 +2.8197 0.707040157641567 0.707038914938007 9.431175972129946e-09 -0.099961962350946 +2.8198000000000003 0.7070401786349607 0.7070389347942825 9.775388443156174e-09 -0.0999619739038789 +2.8199 0.7070401996256961 0.7070389546408105 1.0107297989010722e-08 -0.09996198545330355 +2.82 0.7070402206136419 0.7070389744777257 1.0426831771256917e-08 -0.09996199699922104 +2.8201000000000005 0.7070402415986662 0.7070389943051641 1.0733919818088633e-08 -0.0999620085416324 +2.8202000000000003 0.7070402625806365 0.707039014123262 1.1028495053820586e-08 -0.0999620200805387 +2.8203 0.7070402835594194 0.7070390339321567 1.131049331623557e-08 -0.09996203161594108 +2.8204000000000002 0.7070403045348808 0.7070390537319855 1.1579853355717096e-08 -0.09996204314784052 +2.8205 0.7070403255068863 0.7070390735228873 1.1836516858668156e-08 -0.09996205467623814 +2.8206 0.7070403464753008 0.7070390933050008 1.2080428462256376e-08 -0.09996206620113499 +2.8207000000000004 0.7070403674399881 0.7070391130784653 1.2311535763087633e-08 -0.09996207772253207 +2.8208 0.7070403884008123 0.7070391328434213 1.2529789322410223e-08 -0.09996208924043057 +2.8209 0.7070404093576362 0.7070391526000092 1.2735142688666268e-08 -0.09996210075483139 +2.821 0.707040430310323 0.7070391723483695 1.2927552396624353e-08 -0.09996211226573569 +2.8211000000000004 0.7070404512587352 0.7070391920886441 1.3106977981257317e-08 -0.09996212377314453 +2.8212 0.7070404722027339 0.7070392118209747 1.3273381986415866e-08 -0.09996213527705894 +2.8213000000000004 0.7070404931421814 0.7070392315455036 1.3426729968298023e-08 -0.09996214677748 +2.8214 0.7070405140769387 0.7070392512623733 1.3566990510194277e-08 -0.09996215827440876 +2.8215 0.7070405350068666 0.7070392709717265 1.3694135221620218e-08 -0.09996216976784628 +2.8216000000000006 0.7070405559318262 0.7070392906737062 1.3808138749592247e-08 -0.09996218125779366 +2.8217000000000003 0.7070405768516776 0.707039310368456 1.3908978773423397e-08 -0.09996219274425193 +2.8218 0.707040597766281 0.7070393300561192 1.3996636023805298e-08 -0.09996220422722214 +2.8219000000000003 0.7070406186754967 0.7070393497368397 1.4071094281073449e-08 -0.09996221570670538 +2.822 0.7070406395791842 0.7070393694107611 1.4132340367400964e-08 -0.09996222718270265 +2.8221000000000003 0.7070406604772037 0.7070393890780273 1.4180364161543724e-08 -0.09996223865521506 +2.8222000000000005 0.7070406813694147 0.7070394087387826 1.4215158597105648e-08 -0.09996225012424363 +2.8223000000000003 0.7070407022556771 0.7070394283931705 1.42367196625387e-08 -0.09996226158978944 +2.8224 0.7070407231358506 0.7070394480413356 1.4245046396806071e-08 -0.09996227305185358 +2.8225 0.707040744009795 0.7070394676834213 1.4240140891116915e-08 -0.09996228451043704 +2.8226000000000004 0.7070407648773698 0.7070394873195722 1.4222008299334676e-08 -0.0999622959655409 +2.8227 0.7070407857384349 0.7070395069499318 1.4190656810221525e-08 -0.09996230741716623 +2.8228 0.7070408065928505 0.7070395265746439 1.4146097674326563e-08 -0.09996231886531409 +2.8229 0.7070408274404767 0.7070395461938523 1.4088345174495531e-08 -0.09996233030998554 +2.823 0.707040848281174 0.7070395658077 1.4017416644952763e-08 -0.09996234175118163 +2.8231 0.7070408691148028 0.70703958541633 1.3933332446147695e-08 -0.09996235318890337 +2.8232000000000004 0.7070408899412239 0.7070396050198859 1.3836115970826401e-08 -0.09996236462315188 +2.8233 0.7070409107602986 0.7070396246185097 1.3725793629286442e-08 -0.09996237605392816 +2.8234 0.707040931571888 0.7070396442123437 1.360239485718312e-08 -0.09996238748123325 +2.8235 0.7070409523758543 0.7070396638015302 1.3465952092110711e-08 -0.09996239890506826 +2.8236000000000003 0.7070409731720595 0.7070396833862103 1.3316500766663575e-08 -0.09996241032543424 +2.8237 0.7070409939603661 0.7070397029665256 1.3154079311905598e-08 -0.09996242174233225 +2.8238000000000003 0.7070410147406376 0.7070397225426168 1.2978729139155598e-08 -0.09996243315576334 +2.8239 0.7070410355127371 0.7070397421146237 1.27904946269769e-08 -0.09996244456572854 +2.824 0.7070410562765289 0.7070397616826862 1.2589423115105802e-08 -0.09996245597222896 +2.8241000000000005 0.7070410770318774 0.707039781246943 1.2375564890573787e-08 -0.09996246737526551 +2.8242000000000003 0.7070410977786474 0.7070398008075331 1.2148973172095012e-08 -0.09996247877483931 +2.8243 0.7070411185167051 0.7070398203645945 1.190970410486214e-08 -0.09996249017095146 +2.8244000000000002 0.707041139245917 0.7070398399182644 1.165781673799493e-08 -0.09996250156360299 +2.8245 0.7070411599661501 0.7070398594686791 1.139337301760135e-08 -0.0999625129527949 +2.8246 0.7070411806772721 0.7070398790159751 1.1116437766828247e-08 -0.09996252433852833 +2.8247000000000004 0.7070412013791514 0.7070398985602873 1.0827078665912038e-08 -0.09996253572080425 +2.8248 0.7070412220716575 0.7070399181017502 1.0525366245239809e-08 -0.09996254709962375 +2.8249 0.7070412427546605 0.7070399376404976 1.021137386626736e-08 -0.09996255847498793 +2.825 0.7070412634280311 0.7070399571766619 9.885177698967795e-09 -0.09996256984689772 +2.8251000000000004 0.7070412840916411 0.7070399767103756 9.546856707953744e-09 -0.09996258121535428 +2.8252 0.7070413047453634 0.7070399962417693 9.196492629925945e-09 -0.09996259258035858 +2.8253000000000004 0.7070413253890709 0.7070400157709733 8.834169952856574e-09 -0.09996260394191168 +2.8254 0.7070413460226388 0.707040035298117 8.459975900376726e-09 -0.09996261530001468 +2.8255 0.7070413666459417 0.7070400548233284 8.074000409225013e-09 -0.09996262665466854 +2.8256000000000006 0.7070413872588569 0.7070400743467351 7.67633610756352e-09 -0.09996263800587436 +2.8257000000000003 0.7070414078612612 0.7070400938684633 7.267078287222228e-09 -0.0999626493536332 +2.8258 0.7070414284530335 0.7070401133886377 6.846324892423317e-09 -0.09996266069794607 +2.8259000000000003 0.7070414490340535 0.707040132907383 6.41417648682141e-09 -0.09996267203881407 +2.826 0.7070414696042018 0.7070401524248218 5.970736232686902e-09 -0.0999626833762382 +2.8261000000000003 0.7070414901633602 0.7070401719410759 5.5161098674871845e-09 -0.09996269471021951 +2.8262000000000005 0.7070415107114119 0.7070401914562662 5.050405676998437e-09 -0.09996270604075908 +2.8263000000000003 0.7070415312482408 0.7070402109705117 4.573734469284774e-09 -0.09996271736785786 +2.8264 0.7070415517737325 0.7070402304839313 4.08620954954475e-09 -0.099962728691517 +2.8265 0.7070415722877739 0.7070402499966417 3.5879466923557923e-09 -0.09996274001173752 +2.8266000000000004 0.7070415927902525 0.7070402695087588 3.0790641147859787e-09 -0.09996275132852042 +2.8267 0.7070416132810582 0.7070402890203966 2.559682449505829e-09 -0.0999627626418668 +2.8268 0.707041633760081 0.7070403085316685 2.0299247135632803e-09 -0.09996277395177766 +2.8269 0.7070416542272131 0.707040328042686 1.4899162797607501e-09 -0.09996278525825401 +2.827 0.707041674682348 0.70704034755356 9.397848488995608e-10 -0.09996279656129703 +2.8271 0.7070416951253803 0.707040367064399 3.7966041855491683e-10 -0.09996280786090762 +2.8272000000000004 0.7070417155562059 0.7070403865753107 -1.903247455470325e-10 -0.0999628191570869 +2.8273 0.7070417359747226 0.7070404060864013 -7.700361468257477e-10 -0.0999628304498359 +2.8274 0.7070417563808294 0.7070404255977751 -1.3593370812650662e-09 -0.09996284173915562 +2.8275 0.7070417767744269 0.7070404451095356 -1.9580886773118422e-09 -0.09996285302504714 +2.8276000000000003 0.7070417971554173 0.707040464621784 -2.566149924498884e-09 -0.09996286430751149 +2.8277 0.7070418175237039 0.7070404841346207 -3.183377702067891e-09 -0.09996287558654968 +2.8278000000000003 0.7070418378791921 0.7070405036481442 -3.8096268232049035e-09 -0.09996288686216283 +2.8279 0.7070418582217883 0.7070405231624513 -4.444750062795877e-09 -0.09996289813435189 +2.828 0.7070418785514012 0.7070405426776372 -5.088598195590599e-09 -0.09996290940311789 +2.8281000000000005 0.707041898867941 0.7070405621937959 -5.741020023090904e-09 -0.099962920668462 +2.8282000000000003 0.7070419191713189 0.7070405817110191 -6.401862419520843e-09 -0.09996293193038515 +2.8283 0.7070419394614487 0.7070406012293974 -7.070970356980177e-09 -0.09996294318888842 +2.8284000000000002 0.7070419597382449 0.7070406207490193 -7.748186953149272e-09 -0.09996295444397284 +2.8285 0.7070419800016245 0.7070406402699719 -8.433353501646756e-09 -0.09996296569563941 +2.8286000000000002 0.7070420002515059 0.7070406597923404 -9.126309506723995e-09 -0.09996297694388923 +2.8287000000000004 0.7070420204878092 0.7070406793162084 -9.826892725765812e-09 -0.0999629881887233 +2.8288 0.7070420407104558 0.7070406988416575 -1.0534939209189131e-08 -0.09996299943014264 +2.8289 0.7070420609193706 0.7070407183687677 -1.1250283329065913e-08 -0.09996301066814836 +2.829 0.7070420811144783 0.7070407378976171 -1.1972757828562774e-08 -0.09996302190274141 +2.8291000000000004 0.7070421012957062 0.7070407574282818 -1.2702193853599691e-08 -0.0999630331339228 +2.8292 0.7070421214629841 0.7070407769608367 -1.3438420998386491e-08 -0.09996304436169372 +2.8293000000000004 0.7070421416162425 0.7070407964953542 -1.4181267340984682e-08 -0.09996305558605509 +2.8294 0.7070421617554141 0.7070408160319055 -1.493055947973665e-08 -0.09996306680700798 +2.8295 0.7070421818804342 0.707040835570559 -1.5686122584873674e-08 -0.09996307802455341 +2.8296000000000006 0.7070422019912391 0.7070408551113817 -1.644778042930728e-08 -0.0999630892386924 +2.8297000000000003 0.7070422220877676 0.7070408746544388 -1.721535543416572e-08 -0.09996310044942598 +2.8298 0.7070422421699598 0.7070408941997937 -1.798866870999366e-08 -0.09996311165675521 +2.8299000000000003 0.7070422622377583 0.7070409137475072 -1.8767540096217145e-08 -0.0999631228606811 +2.83 0.7070422822911079 0.7070409332976391 -1.9551788204945353e-08 -0.09996313406120473 +2.8301000000000003 0.7070423023299544 0.7070409528502464 -2.0341230464338694e-08 -0.09996314525832709 +2.8302000000000005 0.7070423223542464 0.7070409724053842 -2.1135683157206403e-08 -0.09996315645204921 +2.8303000000000003 0.707042342363934 0.7070409919631064 -2.1934961468711434e-08 -0.09996316764237219 +2.8304 0.7070423623589699 0.7070410115234642 -2.273887952496806e-08 -0.099963178829297 +2.8305 0.7070423823393079 0.7070410310865065 -2.3547250436409956e-08 -0.09996319001282467 +2.8306000000000004 0.7070424023049048 0.7070410506522812 -2.435988634506142e-08 -0.09996320119295626 +2.8307 0.7070424222557186 0.707041070220833 -2.5176598467471778e-08 -0.09996321236969274 +2.8308 0.7070424421917096 0.7070410897922057 -2.599719713287929e-08 -0.09996322354303522 +2.8309 0.7070424621128406 0.7070411093664404 -2.682149183525287e-08 -0.09996323471298468 +2.831 0.7070424820190757 0.707041128943576 -2.764929127123915e-08 -0.09996324587954215 +2.8311 0.7070425019103821 0.7070411485236496 -2.8480403386349495e-08 -0.09996325704270871 +2.8312000000000004 0.7070425217867278 0.7070411681066964 -2.931463542288175e-08 -0.09996326820248534 +2.8313 0.7070425416480836 0.7070411876927492 -3.01517939600357e-08 -0.09996327935887304 +2.8314 0.7070425614944225 0.707041207281839 -3.0991684960967464e-08 -0.0999632905118729 +2.8315 0.7070425813257195 0.7070412268739945 -3.183411381767545e-08 -0.09996330166148598 +2.8316000000000003 0.7070426011419515 0.7070412464692422 -3.2678885392850576e-08 -0.09996331280771324 +2.8317 0.7070426209430972 0.7070412660676069 -3.352580407170111e-08 -0.09996332395055571 +2.8318000000000003 0.7070426407291382 0.7070412856691106 -3.4374673799682925e-08 -0.09996333509001444 +2.8319 0.7070426605000577 0.7070413052737741 -3.52252981356254e-08 -0.09996334622609046 +2.832 0.7070426802558412 0.7070413248816155 -3.607748029000376e-08 -0.0999633573587848 +2.8321000000000005 0.7070426999964757 0.7070413444926509 -3.693102317524604e-08 -0.09996336848809843 +2.8322000000000003 0.7070427197219515 0.7070413641068942 -3.778572944920962e-08 -0.09996337961403244 +2.8323 0.70704273943226 0.7070413837243572 -3.864140156115137e-08 -0.0999633907365878 +2.8324000000000003 0.7070427591273953 0.7070414033450496 -3.9497841796505215e-08 -0.09996340185576559 +2.8325 0.7070427788073537 0.7070414229689793 -4.0354852325345976e-08 -0.09996341297156686 +2.8326000000000002 0.7070427984721326 0.7070414425961516 -4.121223524472745e-08 -0.09996342408399257 +2.8327000000000004 0.7070428181217328 0.7070414622265697 -4.206979262695652e-08 -0.09996343519304374 +2.8328 0.7070428377561567 0.7070414818602351 -4.292732656228362e-08 -0.09996344629872146 +2.8329 0.7070428573754087 0.7070415014971467 -4.378463920841688e-08 -0.0999634574010267 +2.833 0.7070428769794956 0.7070415211373017 -4.4641532833029646e-08 -0.09996346849996054 +2.8331000000000004 0.7070428965684257 0.7070415407806947 -4.549780986128917e-08 -0.09996347959552392 +2.8332 0.7070429161422103 0.7070415604273184 -4.635327291945511e-08 -0.09996349068771787 +2.8333000000000004 0.7070429357008622 0.7070415800771637 -4.720772488203554e-08 -0.09996350177654346 +2.8334 0.7070429552443966 0.7070415997302186 -4.8060968917194684e-08 -0.09996351286200171 +2.8335 0.7070429747728308 0.7070416193864699 -4.891280853079865e-08 -0.0999635239440936 +2.8336000000000006 0.7070429942861842 0.7070416390459021 -4.9763047611870587e-08 -0.09996353502282024 +2.8337000000000003 0.7070430137844783 0.707041658708497 -5.0611490479374015e-08 -0.0999635460981826 +2.8338 0.7070430332677361 0.7070416783742347 -5.1457941925743544e-08 -0.09996355717018167 +2.8339000000000003 0.7070430527359839 0.7070416980430934 -5.2302207261337164e-08 -0.09996356823881852 +2.834 0.7070430721892489 0.7070417177150486 -5.314409236159903e-08 -0.09996357930409414 +2.8341000000000003 0.707043091627561 0.7070417373900744 -5.398340370880127e-08 -0.0999635903660095 +2.8342 0.7070431110509521 0.7070417570681429 -5.481994843812253e-08 -0.09996360142456576 +2.8343000000000003 0.7070431304594561 0.707041776749223 -5.5653534381232966e-08 -0.0999636124797638 +2.8344 0.7070431498531089 0.7070417964332829 -5.648397010944543e-08 -0.09996362353160469 +2.8345 0.7070431692319488 0.7070418161202883 -5.7311064982070933e-08 -0.0999636345800895 +2.8346000000000005 0.7070431885960153 0.7070418358102023 -5.8134629185666725e-08 -0.09996364562521917 +2.8347 0.7070432079453514 0.7070418555029867 -5.895447377762125e-08 -0.09996365666699482 +2.8348 0.7070432272800005 0.7070418751986012 -5.977041073234116e-08 -0.09996366770541738 +2.8349 0.7070432466000086 0.7070418948970028 -6.058225298245096e-08 -0.0999636787404879 +2.835 0.707043265905424 0.7070419145981474 -6.138981446324535e-08 -0.09996368977220735 +2.8351 0.7070432851962971 0.7070419343019883 -6.219291015258782e-08 -0.09996370080057684 +2.8352000000000004 0.7070433044726794 0.7070419540084771 -6.299135611471246e-08 -0.0999637118255973 +2.8353 0.7070433237346253 0.7070419737175635 -6.378496954272464e-08 -0.09996372284726977 +2.8354 0.7070433429821905 0.7070419934291947 -6.457356880066809e-08 -0.09996373386559528 +2.8355 0.7070433622154331 0.7070420131433168 -6.535697346602559e-08 -0.0999637448805748 +2.8356000000000003 0.7070433814344128 0.7070420328598739 -6.613500436614822e-08 -0.09996375589220946 +2.8357 0.7070434006391915 0.7070420525788069 -6.690748362379179e-08 -0.09996376690050013 +2.8358000000000003 0.7070434198298328 0.7070420723000566 -6.767423469831654e-08 -0.09996377790544793 +2.8359 0.7070434390064022 0.7070420920235605 -6.84350824216827e-08 -0.09996378890705387 +2.836 0.7070434581689669 0.7070421117492554 -6.918985304398689e-08 -0.09996379990531892 +2.8361000000000005 0.7070434773175964 0.7070421314770753 -6.993837426728933e-08 -0.09996381090024414 +2.8362000000000003 0.7070434964523613 0.7070421512069527 -7.068047529071655e-08 -0.09996382189183049 +2.8363 0.7070435155733348 0.7070421709388185 -7.141598684342124e-08 -0.099963832880079 +2.8364000000000003 0.7070435346805919 0.7070421906726014 -7.214474122578182e-08 -0.09996384386499071 +2.8365 0.7070435537742082 0.7070422104082287 -7.286657235320432e-08 -0.09996385484656657 +2.8366000000000002 0.7070435728542623 0.7070422301456256 -7.358131578431154e-08 -0.09996386582480764 +2.8367000000000004 0.7070435919208345 0.707042249884716 -7.428880876387753e-08 -0.09996387679971497 +2.8368 0.7070436109740061 0.7070422696254216 -7.498889026012409e-08 -0.09996388777128946 +2.8369 0.7070436300138605 0.7070422893676627 -7.56814009989816e-08 -0.09996389873953221 +2.837 0.7070436490404832 0.7070423091113579 -7.63661835000845e-08 -0.09996390970444431 +2.8371000000000004 0.7070436680539605 0.7070423288564238 -7.70430821136342e-08 -0.09996392066602665 +2.8372 0.7070436870543807 0.7070423486027759 -7.771194306376711e-08 -0.09996393162428024 +2.8373000000000004 0.7070437060418342 0.7070423683503273 -7.837261446416721e-08 -0.09996394257920611 +2.8374 0.7070437250164121 0.7070423880989903 -7.902494637140878e-08 -0.09996395353080527 +2.8375 0.7070437439782083 0.7070424078486752 -7.966879081010986e-08 -0.09996396447907878 +2.8376000000000006 0.7070437629273171 0.7070424275992907 -8.03040018110962e-08 -0.09996397542402757 +2.8377000000000003 0.7070437818638348 0.7070424473507441 -8.093043543482004e-08 -0.09996398636565268 +2.8378 0.7070438007878594 0.7070424671029412 -8.154794981559549e-08 -0.09996399730395514 +2.8379000000000003 0.7070438196994902 0.7070424868557861 -8.215640518588474e-08 -0.09996400823893592 +2.838 0.707043838598828 0.7070425066091813 -8.275566391099248e-08 -0.09996401917059605 +2.8381000000000003 0.7070438574859752 0.7070425263630288 -8.334559051942358e-08 -0.09996403009893658 +2.8382 0.7070438763610354 0.7070425461172282 -8.392605173844492e-08 -0.09996404102395849 +2.8383000000000003 0.7070438952241136 0.7070425658716777 -8.449691651403468e-08 -0.09996405194566275 +2.8384 0.7070439140753164 0.7070425856262748 -8.505805604991368e-08 -0.09996406286405041 +2.8385 0.7070439329147513 0.7070426053809147 -8.560934382922936e-08 -0.09996407377912242 +2.8386000000000005 0.7070439517425278 0.7070426251354924 -8.615065564838292e-08 -0.09996408469087989 +2.8387000000000002 0.7070439705587563 0.7070426448899004 -8.668186964391755e-08 -0.0999640955993237 +2.8388 0.7070439893635485 0.7070426646440309 -8.720286631680452e-08 -0.09996410650445492 +2.8389 0.7070440081570175 0.7070426843977744 -8.771352856713766e-08 -0.09996411740627459 +2.839 0.7070440269392773 0.7070427041510203 -8.821374170974589e-08 -0.09996412830478363 +2.8391 0.7070440457104433 0.7070427239036564 -8.870339350194878e-08 -0.09996413919998309 +2.8392000000000004 0.7070440644706322 0.7070427436555704 -8.918237417998576e-08 -0.09996415009187401 +2.8393 0.7070440832199619 0.7070427634066474 -8.96505764676897e-08 -0.09996416098045738 +2.8394 0.7070441019585512 0.7070427831567723 -9.010789561551824e-08 -0.09996417186573416 +2.8395 0.7070441206865201 0.7070428029058287 -9.055422941356417e-08 -0.09996418274770541 +2.8396000000000003 0.7070441394039892 0.7070428226536991 -9.098947821497422e-08 -0.09996419362637206 +2.8397 0.7070441581110811 0.7070428424002648 -9.141354496543935e-08 -0.09996420450173517 +2.8398000000000003 0.7070441768079185 0.707042862145407 -9.182633521880729e-08 -0.09996421537379577 +2.8399 0.7070441954946256 0.7070428818890047 -9.222775715442971e-08 -0.0999642262425548 +2.84 0.7070442141713275 0.7070429016309361 -9.261772160838733e-08 -0.09996423710801328 +2.8401000000000005 0.7070442328381499 0.7070429213710794 -9.299614208389817e-08 -0.09996424797017221 +2.8402000000000003 0.7070442514952197 0.7070429411093107 -9.336293477300167e-08 -0.09996425882903254 +2.8403 0.7070442701426647 0.7070429608455064 -9.371801857997741e-08 -0.09996426968459542 +2.8404000000000003 0.7070442887806134 0.7070429805795415 -9.406131513088611e-08 -0.09996428053686174 +2.8405 0.707044307409195 0.7070430003112902 -9.439274879785575e-08 -0.09996429138583252 +2.8406000000000002 0.7070443260285397 0.7070430200406256 -9.471224671469408e-08 -0.09996430223150876 +2.8407000000000004 0.7070443446387784 0.7070430397674207 -9.50197387890317e-08 -0.09996431307389148 +2.8408 0.7070443632400425 0.7070430594915472 -9.531515771880189e-08 -0.09996432391298163 +2.8409 0.7070443818324648 0.7070430792128766 -9.559843900958792e-08 -0.0999643347487803 +2.841 0.7070444004161773 0.7070430989312794 -9.586952098416396e-08 -0.09996434558128836 +2.8411000000000004 0.7070444189913141 0.7070431186466255 -9.612834480331178e-08 -0.09996435641050688 +2.8412 0.7070444375580094 0.7070431383587845 -9.637485446668814e-08 -0.0999643672364369 +2.8413000000000004 0.7070444561163978 0.7070431580676251 -9.660899683971297e-08 -0.09996437805907935 +2.8414 0.7070444746666142 0.7070431777730151 -9.683072165356937e-08 -0.09996438887843517 +2.8415 0.7070444932087951 0.7070431974748231 -9.70399815199488e-08 -0.09996439969450553 +2.8416000000000006 0.7070445117430761 0.7070432171729163 -9.723673194059201e-08 -0.09996441050729132 +2.8417000000000003 0.7070445302695941 0.7070432368671613 -9.742093131856477e-08 -0.09996442131679358 +2.8418 0.7070445487884862 0.7070432565574247 -9.759254096519676e-08 -0.09996443212301329 +2.8419 0.7070445672998897 0.7070432762435723 -9.775152510615309e-08 -0.0999644429259514 +2.842 0.7070445858039426 0.7070432959254702 -9.789785089271003e-08 -0.09996445372560897 +2.8421000000000003 0.7070446043007829 0.7070433156029836 -9.80314884078265e-08 -0.09996446452198698 +2.8422 0.7070446227905487 0.7070433352759775 -9.815241066614411e-08 -0.09996447531508638 +2.8423000000000003 0.7070446412733792 0.7070433549443169 -9.826059363133438e-08 -0.09996448610490823 +2.8424 0.7070446597494129 0.7070433746078664 -9.83560162056904e-08 -0.09996449689145344 +2.8425 0.7070446782187887 0.7070433942664904 -9.843866024747405e-08 -0.09996450767472305 +2.8426000000000005 0.7070446966816464 0.7070434139200537 -9.85085105648445e-08 -0.09996451845471814 +2.8427000000000002 0.7070447151381252 0.7070434335684199 -9.856555492626651e-08 -0.09996452923143961 +2.8428 0.7070447335883641 0.7070434532114533 -9.860978405877574e-08 -0.09996454000488847 +2.8429 0.7070447520325029 0.707043472849018 -9.864119164797874e-08 -0.09996455077506575 +2.843 0.7070447704706813 0.7070434924809778 -9.865977433545087e-08 -0.09996456154197238 +2.8431 0.7070447889030385 0.7070435121071966 -9.866553172654252e-08 -0.09996457230560937 +2.8432000000000004 0.707044807329714 0.7070435317275388 -9.865846638951181e-08 -0.09996458306597773 +2.8433 0.7070448257508476 0.707043551341868 -9.863858384077939e-08 -0.09996459382307848 +2.8434 0.7070448441665782 0.7070435709500484 -9.860589256140834e-08 -0.0999646045769125 +2.8435 0.7070448625770452 0.7070435905519448 -9.85604039797569e-08 -0.09996461532748091 +2.8436000000000003 0.7070448809823877 0.7070436101474213 -9.850213247581535e-08 -0.09996462607478465 +2.8437 0.7070448993827443 0.7070436297363427 -9.843109537166495e-08 -0.09996463681882471 +2.8438000000000003 0.7070449177782541 0.7070436493185739 -9.834731293147797e-08 -0.09996464755960209 +2.8439 0.7070449361690551 0.7070436688939798 -9.82508083554462e-08 -0.09996465829711779 +2.844 0.7070449545552855 0.707043688462426 -9.814160777023989e-08 -0.09996466903137279 +2.8441000000000005 0.7070449729370833 0.7070437080237783 -9.801974022380366e-08 -0.09996467976236811 +2.8442000000000003 0.7070449913145853 0.7070437275779025 -9.788523767841756e-08 -0.09996469049010463 +2.8443 0.707045009687929 0.7070437471246652 -9.773813500115608e-08 -0.09996470121458345 +2.8444000000000003 0.7070450280572512 0.7070437666639333 -9.757846995521458e-08 -0.09996471193580553 +2.8445 0.7070450464226876 0.7070437861955738 -9.74062831938377e-08 -0.09996472265377179 +2.8446000000000002 0.7070450647843745 0.707043805719455 -9.722161824210485e-08 -0.09996473336848336 +2.8447000000000005 0.7070450831424466 0.7070438252354447 -9.7024521494328e-08 -0.0999647440799411 +2.8448 0.7070451014970389 0.707043844743412 -9.681504219843928e-08 -0.09996475478814604 +2.8449 0.7070451198482854 0.7070438642432263 -9.659323244384788e-08 -0.09996476549309923 +2.845 0.7070451381963196 0.7070438837347575 -9.635914714929694e-08 -0.0999647761948016 +2.8451000000000004 0.7070451565412745 0.7070439032178759 -9.611284404725112e-08 -0.09996478689325408 +2.8452 0.707045174883282 0.7070439226924534 -9.585438367609028e-08 -0.09996479758845778 +2.8453000000000004 0.7070451932224738 0.7070439421583614 -9.558382935408866e-08 -0.09996480828041354 +2.8454 0.707045211558981 0.7070439616154727 -9.530124717681276e-08 -0.09996481896912246 +2.8455 0.7070452298929337 0.7070439810636607 -9.500670599803945e-08 -0.0999648296545855 +2.8456000000000006 0.7070452482244607 0.7070440005027996 -9.47002774002656e-08 -0.09996484033680364 +2.8457000000000003 0.7070452665536908 0.7070440199327641 -9.438203568863657e-08 -0.09996485101577779 +2.8458 0.7070452848807519 0.7070440393534306 -9.405205787446635e-08 -0.09996486169150907 +2.8459 0.7070453032057706 0.7070440587646751 -9.371042365615562e-08 -0.09996487236399838 +2.846 0.7070453215288731 0.7070440781663756 -9.335721539490555e-08 -0.09996488303324674 +2.8461000000000003 0.7070453398501844 0.7070440975584105 -9.299251809043174e-08 -0.09996489369925515 +2.8462 0.7070453581698282 0.7070441169406592 -9.261641937402532e-08 -0.09996490436202457 +2.8463000000000003 0.7070453764879279 0.7070441363130016 -9.22290094833994e-08 -0.09996491502155595 +2.8464 0.7070453948046053 0.7070441556753198 -9.183038123406623e-08 -0.09996492567785033 +2.8465 0.7070454131199817 0.7070441750274957 -9.142063000285722e-08 -0.09996493633090862 +2.8466000000000005 0.707045431434177 0.707044194369413 -9.099985370537161e-08 -0.09996494698073187 +2.8467000000000002 0.70704544974731 0.7070442137009563 -9.056815277169034e-08 -0.099964957627321 +2.8468 0.7070454680594989 0.707044233022011 -9.012563011688568e-08 -0.09996496827067702 +2.8469 0.70704548637086 0.7070442523324643 -8.967239112714354e-08 -0.09996497891080094 +2.847 0.707045504681509 0.7070442716322037 -8.9208543627671e-08 -0.09996498954769373 +2.8471 0.70704552299156 0.7070442909211185 -8.873419785927761e-08 -0.09996500018135629 +2.8472000000000004 0.7070455413011265 0.7070443101990993 -8.824946644715032e-08 -0.09996501081178975 +2.8473 0.70704555961032 0.7070443294660378 -8.775446438003681e-08 -0.09996502143899501 +2.8474 0.7070455779192515 0.7070443487218263 -8.72493089859594e-08 -0.09996503206297302 +2.8475 0.70704559622803 0.7070443679663594 -8.673411989925522e-08 -0.09996504268372486 +2.8476000000000004 0.7070456145367636 0.7070443871995322 -8.620901902848394e-08 -0.09996505330125138 +2.8477 0.7070456328455589 0.7070444064212416 -8.567413053300887e-08 -0.0999650639155536 +2.8478000000000003 0.7070456511545213 0.7070444256313861 -8.512958079784361e-08 -0.09996507452663256 +2.8479 0.7070456694637546 0.707044444829865 -8.45754983911512e-08 -0.09996508513448918 +2.848 0.7070456877733613 0.7070444640165792 -8.401201404689695e-08 -0.09996509573912443 +2.8481000000000005 0.7070457060834426 0.707044483191431 -8.343926062841928e-08 -0.09996510634053934 +2.8482000000000003 0.7070457243940982 0.7070445023543245 -8.285737309633723e-08 -0.09996511693873487 +2.8483 0.7070457427054258 0.7070445215051648 -8.226648847472345e-08 -0.09996512753371195 +2.8484000000000003 0.7070457610175227 0.7070445406438588 -8.16667458233486e-08 -0.09996513812547164 +2.8485 0.7070457793304836 0.7070445597703151 -8.105828620558891e-08 -0.09996514871401489 +2.8486000000000002 0.707045797644402 0.707044578884443 -8.044125265373181e-08 -0.0999651592993426 +2.8487000000000005 0.7070458159593702 0.7070445979861544 -7.981579013428136e-08 -0.09996516988145582 +2.8488 0.7070458342754784 0.7070446170753621 -7.918204551152913e-08 -0.09996518046035552 +2.8489 0.7070458525928159 0.7070446361519807 -7.854016752066595e-08 -0.09996519103604268 +2.849 0.7070458709114696 0.7070446552159264 -7.789030672441383e-08 -0.09996520160851828 +2.8491000000000004 0.7070458892315249 0.7070446742671171 -7.723261548180094e-08 -0.09996521217778322 +2.8492 0.707045907553066 0.7070446933054726 -7.656724791780395e-08 -0.09996522274383858 +2.8493000000000004 0.707045925876175 0.7070447123309137 -7.589435987390841e-08 -0.09996523330668527 +2.8494 0.7070459442009325 0.7070447313433632 -7.521410888122054e-08 -0.09996524386632426 +2.8495 0.7070459625274174 0.7070447503427462 -7.452665412750747e-08 -0.09996525442275656 +2.8496000000000006 0.7070459808557068 0.707044769328989 -7.383215640732396e-08 -0.09996526497598315 +2.8497000000000003 0.7070459991858761 0.7070447883020192 -7.313077809729257e-08 -0.09996527552600497 +2.8498 0.7070460175179987 0.707044807261767 -7.24226831079651e-08 -0.09996528607282301 +2.8499 0.7070460358521466 0.7070448262081638 -7.170803685259755e-08 -0.09996529661643823 +2.85 0.7070460541883898 0.7070448451411431 -7.098700620421575e-08 -0.09996530715685159 +2.8501000000000003 0.7070460725267964 0.7070448640606403 -7.025975945745139e-08 -0.0999653176940641 +2.8502 0.7070460908674325 0.7070448829665923 -6.952646629211287e-08 -0.09996532822807665 +2.8503000000000003 0.7070461092103633 0.7070449018589379 -6.878729773111825e-08 -0.09996533875889028 +2.8504 0.707046127555651 0.7070449207376182 -6.804242610146394e-08 -0.09996534928650602 +2.8505 0.7070461459033566 0.7070449396025755 -6.729202499172401e-08 -0.09996535981092472 +2.8506000000000005 0.7070461642535391 0.7070449584537541 -6.653626921431996e-08 -0.09996537033214736 +2.8507000000000002 0.7070461826062554 0.7070449772911009 -6.57753347638873e-08 -0.09996538085017503 +2.8508 0.707046200961561 0.707044996114564 -6.500939877781067e-08 -0.09996539136500864 +2.8509 0.7070462193195087 0.7070450149240936 -6.423863949285569e-08 -0.09996540187664912 +2.851 0.7070462376801503 0.7070450337196417 -6.346323620570402e-08 -0.09996541238509753 +2.8511 0.7070462560435344 0.7070450525011625 -6.268336922741688e-08 -0.0999654228903547 +2.8512000000000004 0.707046274409709 0.7070450712686117 -6.18992198461385e-08 -0.09996543339242167 +2.8513 0.7070462927787194 0.7070450900219478 -6.1110970283728e-08 -0.09996544389129947 +2.8514 0.707046311150609 0.7070451087611305 -6.031880365152398e-08 -0.09996545438698895 +2.8515 0.707046329525419 0.7070451274861214 -5.952290390871112e-08 -0.09996546487949108 +2.8516000000000004 0.7070463479031895 0.7070451461968849 -5.87234558209037e-08 -0.09996547536880696 +2.8517 0.7070463662839578 0.7070451648933866 -5.7920644916560626e-08 -0.09996548585493746 +2.8518000000000003 0.7070463846677593 0.7070451835755944 -5.7114657442750016e-08 -0.09996549633788353 +2.8519 0.7070464030546277 0.7070452022434787 -5.630568032264846e-08 -0.09996550681764624 +2.852 0.7070464214445946 0.7070452208970108 -5.549390111455818e-08 -0.09996551729422648 +2.8521000000000005 0.707046439837689 0.7070452395361648 -5.4679507963985297e-08 -0.09996552776762518 +2.8522000000000003 0.7070464582339389 0.7070452581609172 -5.38626895633075e-08 -0.09996553823784342 +2.8523 0.7070464766333693 0.7070452767712452 -5.304363510775546e-08 -0.09996554870488208 +2.8524000000000003 0.7070464950360035 0.7070452953671292 -5.222253425096052e-08 -0.0999655591687421 +2.8525 0.7070465134418633 0.7070453139485515 -5.139957706093608e-08 -0.09996556962942453 +2.8526000000000002 0.7070465318509673 0.7070453325154961 -5.0574953975625336e-08 -0.09996558008693028 +2.8527000000000005 0.7070465502633333 0.7070453510679489 -4.97488557601837e-08 -0.09996559054126028 +2.8528000000000002 0.7070465686789764 0.7070453696058983 -4.892147346296019e-08 -0.09996560099241558 +2.8529 0.7070465870979096 0.7070453881293346 -4.8092998369635674e-08 -0.0999656114403971 +2.853 0.7070466055201438 0.7070454066382502 -4.726362196050531e-08 -0.09996562188520579 +2.8531000000000004 0.7070466239456883 0.7070454251326397 -4.643353586472523e-08 -0.09996563232684265 +2.8532 0.7070466423745501 0.7070454436124994 -4.560293181721546e-08 -0.09996564276530867 +2.8533000000000004 0.7070466608067338 0.7070454620778277 -4.4772001615942403e-08 -0.09996565320060471 +2.8534 0.7070466792422423 0.7070454805286254 -4.3940937074810234e-08 -0.09996566363273185 +2.8535 0.7070466976810764 0.7070454989648949 -4.310992998006241e-08 -0.09996567406169096 +2.8536000000000006 0.7070467161232348 0.7070455173866409 -4.2279172046235975e-08 -0.09996568448748303 +2.8537000000000003 0.7070467345687141 0.7070455357938705 -4.14488548732678e-08 -0.09996569491010904 +2.8538 0.7070467530175091 0.7070455541865921 -4.061916990060572e-08 -0.09996570532956991 +2.8539 0.7070467714696118 0.7070455725648166 -3.9790308365155076e-08 -0.09996571574586662 +2.854 0.7070467899250134 0.7070455909285573 -3.8962461253058776e-08 -0.09996572615900019 +2.8541000000000003 0.7070468083837016 0.7070456092778288 -3.813581926062539e-08 -0.09996573656897145 +2.8542 0.7070468268456633 0.707045627612648 -3.731057274778977e-08 -0.09996574697578145 +2.8543000000000003 0.7070468453108827 0.7070456459330348 -3.6486911695991775e-08 -0.09996575737943121 +2.8544 0.7070468637793421 0.7070456642390093 -3.5665025659441414e-08 -0.09996576777992158 +2.8545 0.7070468822510219 0.7070456825305953 -3.484510372885226e-08 -0.09996577817725358 +2.8546000000000005 0.7070469007259002 0.7070457008078175 -3.4027334482869195e-08 -0.09996578857142813 +2.8547000000000002 0.707046919203953 0.7070457190707029 -3.321190594654348e-08 -0.09996579896244617 +2.8548 0.7070469376851548 0.7070457373192813 -3.23990055487236e-08 -0.09996580935030872 +2.8549 0.7070469561694779 0.7070457555535834 -3.158882007597667e-08 -0.0999658197350167 +2.855 0.7070469746568923 0.7070457737736424 -3.0781535634641366e-08 -0.09996583011657105 +2.8551 0.7070469931473663 0.7070457919794939 -2.9977337602689336e-08 -0.09996584049497279 +2.8552000000000004 0.707047011640866 0.7070458101711745 -2.9176410590693938e-08 -0.0999658508702228 +2.8553 0.7070470301373559 0.7070458283487236 -2.8378938398462145e-08 -0.09996586124232212 +2.8554 0.7070470486367983 0.7070458465121824 -2.758510397448538e-08 -0.09996587161127167 +2.8555 0.7070470671391538 0.7070458646615936 -2.6795089369101993e-08 -0.09996588197707242 +2.8556000000000004 0.7070470856443802 0.7070458827970023 -2.6009075698284895e-08 -0.09996589233972528 +2.8557 0.7070471041524345 0.7070459009184555 -2.522724310049032e-08 -0.09996590269923127 +2.8558000000000003 0.707047122663271 0.707045919026002 -2.4449770691988698e-08 -0.09996591305559129 +2.8559 0.707047141176842 0.7070459371196924 -2.3676836533037537e-08 -0.09996592340880628 +2.856 0.7070471596930987 0.7070459551995796 -2.2908617579309176e-08 -0.09996593375887726 +2.8561000000000005 0.7070471782119899 0.7070459732657177 -2.2145289645461586e-08 -0.09996594410580513 +2.8562000000000003 0.7070471967334622 0.7070459913181633 -2.138702736480605e-08 -0.09996595444959082 +2.8563 0.7070472152574612 0.707046009356975 -2.0634004149842206e-08 -0.09996596479023534 +2.8564000000000003 0.70704723378393 0.7070460273822126 -1.988639214888996e-08 -0.09996597512773966 +2.8565 0.7070472523128098 0.7070460453939379 -1.9144362213563415e-08 -0.09996598546210471 +2.8566000000000003 0.7070472708440406 0.7070460633922151 -1.8408083854101753e-08 -0.09996599579333143 +2.8567000000000005 0.7070472893775601 0.7070460813771096 -1.7677725199904265e-08 -0.09996600612142083 +2.8568000000000002 0.7070473079133042 0.7070460993486882 -1.6953452965703247e-08 -0.09996601644637376 +2.8569 0.7070473264512073 0.7070461173070208 -1.6235432411665363e-08 -0.09996602676819127 +2.857 0.7070473449912018 0.707046135252178 -1.552382730479404e-08 -0.0999660370868743 +2.8571000000000004 0.7070473635332184 0.7070461531842323 -1.4818799880331884e-08 -0.09996604740242371 +2.8572 0.7070473820771861 0.707046171103258 -1.412051080966828e-08 -0.09996605771484053 +2.8573000000000004 0.7070474006230323 0.7070461890093311 -1.3429119160440761e-08 -0.09996606802412568 +2.8574 0.7070474191706826 0.7070462069025298 -1.2744782359238455e-08 -0.09996607833028015 +2.8575 0.7070474377200608 0.7070462247829332 -1.2067656159076012e-08 -0.09996608863330485 +2.8576000000000006 0.7070474562710894 0.7070462426506223 -1.139789459819393e-08 -0.09996609893320074 +2.8577000000000004 0.707047474823689 0.7070462605056795 -1.0735649972302974e-08 -0.09996610922996874 +2.8578 0.707047493377779 0.7070462783481897 -1.0081072797721302e-08 -0.09996611952360984 +2.8579 0.7070475119332765 0.7070462961782383 -9.434311771042148e-09 -0.09996612981412503 +2.858 0.7070475304900974 0.7070463139959131 -8.795513744414007e-09 -0.09996614010151518 +2.8581000000000003 0.7070475490481563 0.7070463318013032 -8.16482368867777e-09 -0.0999661503857813 +2.8582 0.7070475676073655 0.707046349594499 -7.54238465346807e-09 -0.09996616066692432 +2.8583000000000003 0.7070475861676366 0.707046367375592 -6.928337751600788e-09 -0.09996617094494512 +2.8584 0.7070476047288794 0.7070463851446768 -6.3228221087660574e-09 -0.09996618121984474 +2.8585 0.7070476232910023 0.7070464029018477 -5.725974840976866e-09 -0.09996619149162407 +2.8586000000000005 0.7070476418539118 0.7070464206472014 -5.13793102681348e-09 -0.09996620176028406 +2.8587000000000002 0.707047660417514 0.7070464383808357 -4.558823670126888e-09 -0.09996621202582572 +2.8588 0.7070476789817123 0.70704645610285 -3.988783674017948e-09 -0.0999662222882499 +2.8589 0.7070476975464095 0.7070464738133451 -3.427939807010283e-09 -0.09996623254755761 +2.859 0.7070477161115072 0.7070464915124227 -2.8764186796315094e-09 -0.0999662428037498 +2.8591 0.7070477346769053 0.7070465092001865 -2.334344709718772e-09 -0.09996625305682744 +2.8592000000000004 0.7070477532425024 0.707046526876741 -1.801840101602059e-09 -0.09996626330679138 +2.8593 0.7070477718081959 0.7070465445421923 -1.2790248079402877e-09 -0.09996627355364267 +2.8594 0.7070477903738819 0.7070465621966475 -7.66016519312962e-10 -0.09996628379738219 +2.8595 0.7070478089394553 0.707046579840215 -2.629306208520865e-10 -0.0999662940380109 +2.8596000000000004 0.7070478275048098 0.7070465974730047 2.3011982423770672e-10 -0.09996630427552977 +2.8597 0.707047846069838 0.7070466150951271 7.130241041694574e-10 -0.09996631450993972 +2.8598000000000003 0.7070478646344307 0.7070466327066943 1.1856738819926438e-09 -0.09996632474124162 +2.8599 0.7070478831984786 0.7070466503078199 1.6479632138077793e-09 -0.09996633496943652 +2.86 0.7070479017618705 0.7070466678986176 2.099788586930329e-09 -0.09996634519452535 +2.8601000000000005 0.7070479203244947 0.7070466854792028 2.5410489285643267e-09 -0.099966355416509 +2.8602000000000003 0.7070479388862381 0.7070467030496923 2.9716456326905893e-09 -0.09996636563538852 +2.8603 0.7070479574469866 0.7070467206102033 3.391482588689654e-09 -0.09996637585116476 +2.8604000000000003 0.7070479760066248 0.7070467381608541 3.800466195219565e-09 -0.09996638606383866 +2.8605 0.707047994565037 0.7070467557017641 4.198505383634643e-09 -0.0999663962734112 +2.8606000000000003 0.7070480131221062 0.7070467732330539 4.585511640536888e-09 -0.09996640647988332 +2.8607000000000005 0.7070480316777142 0.7070467907548441 4.961399021653767e-09 -0.0999664166832559 +2.8608000000000002 0.7070480502317424 0.7070468082672575 5.326084172654899e-09 -0.09996642688352997 +2.8609 0.7070480687840712 0.7070468257704168 5.6794863551729025e-09 -0.09996643708070639 +2.861 0.7070480873345797 0.7070468432644458 6.0215274502728455e-09 -0.09996644727478611 +2.8611000000000004 0.7070481058831468 0.7070468607494693 6.352131994014076e-09 -0.09996645746577011 +2.8612 0.7070481244296507 0.7070468782256126 6.6712271757154995e-09 -0.09996646765365934 +2.8613000000000004 0.7070481429739681 0.707046895693002 6.97874286484379e-09 -0.09996647783845472 +2.8614 0.7070481615159756 0.7070469131517645 7.274611623156457e-09 -0.09996648802015717 +2.8615 0.707048180055549 0.7070469306020276 7.558768724651166e-09 -0.09996649819876767 +2.8616 0.7070481985925634 0.7070469480439193 7.831152159902544e-09 -0.09996650837428711 +2.8617000000000004 0.7070482171268933 0.7070469654775687 8.091702656878863e-09 -0.09996651854671648 +2.8618 0.7070482356584122 0.7070469829031052 8.340363691350383e-09 -0.09996652871605669 +2.8619 0.7070482541869937 0.7070470003206588 8.577081499899775e-09 -0.09996653888230866 +2.862 0.7070482727125104 0.7070470177303603 8.801805090330461e-09 -0.09996654904547335 +2.8621000000000003 0.7070482912348344 0.7070470351323406 9.014486253809684e-09 -0.09996655920555168 +2.8622 0.7070483097538376 0.7070470525267313 9.215079573542118e-09 -0.0999665693625446 +2.8623000000000003 0.7070483282693911 0.7070470699136645 9.403542435178214e-09 -0.09996657951645305 +2.8624 0.7070483467813662 0.7070470872932726 9.57983504242671e-09 -0.09996658966727795 +2.8625 0.7070483652896327 0.7070471046656883 9.743920407513651e-09 -0.09996659981502024 +2.8626000000000005 0.7070483837940612 0.7070471220310452 9.895764378070604e-09 -0.09996660995968087 +2.8627000000000002 0.7070484022945214 0.7070471393894766 1.0035335635399933e-08 -0.0999666201012608 +2.8628 0.7070484207908827 0.7070471567411165 1.0162605699678973e-08 -0.09996663023976093 +2.8629000000000002 0.7070484392830143 0.7070471740860989 1.0277548944705173e-08 -0.09996664037518221 +2.863 0.7070484577707852 0.7070471914245582 1.0380142587487762e-08 -0.09996665050752561 +2.8631 0.7070484762540639 0.7070472087566289 1.0470366704727618e-08 -0.09996666063679194 +2.8632000000000004 0.707048494732719 0.7070472260824456 1.0548204234551994e-08 -0.09996667076298221 +2.8633 0.7070485132066191 0.7070472434021434 1.0613640979983963e-08 -0.09996668088609739 +2.8634 0.7070485316756325 0.7070472607158573 1.0666665599401437e-08 -0.09996669100613836 +2.8635 0.7070485501396271 0.7070472780237225 1.0707269634292749e-08 -0.09996670112310607 +2.8636000000000004 0.7070485685984715 0.7070472953258737 1.0735447480633709e-08 -0.09996671123700147 +2.8637 0.7070485870520334 0.7070473126224464 1.0751196407102204e-08 -0.09996672134782543 +2.8638000000000003 0.7070486055001812 0.7070473299135758 1.0754516555078197e-08 -0.09996673145557895 +2.8639 0.7070486239427832 0.707047347199397 1.0745410928235388e-08 -0.099966741560263 +2.864 0.7070486423797075 0.7070473644800451 1.0723885396878019e-08 -0.09996675166187846 +2.8641000000000005 0.7070486608108224 0.707047381755655 1.0689948700542962e-08 -0.09996676176042622 +2.8642000000000003 0.7070486792359962 0.7070473990263614 1.0643612432387206e-08 -0.09996677185590727 +2.8643 0.7070486976550979 0.7070474162922991 1.058489104872884e-08 -0.09996678194832252 +2.8644000000000003 0.7070487160679959 0.7070474335536026 1.0513801853434535e-08 -0.09996679203767288 +2.8645 0.7070487344745596 0.707047450810406 1.0430365003991082e-08 -0.09996680212395932 +2.8646000000000003 0.7070487528746581 0.7070474680628432 1.0334603499362327e-08 -0.09996681220718273 +2.8647000000000005 0.7070487712681608 0.7070474853110482 1.0226543173050273e-08 -0.09996682228734402 +2.8648000000000002 0.707048789654938 0.7070475025551546 1.0106212691360361e-08 -0.09996683236444422 +2.8649 0.7070488080348596 0.7070475197952948 9.973643542125765e-09 -0.09996684243848417 +2.865 0.7070488264077963 0.7070475370316018 9.82887002343169e-09 -0.09996685250946478 +2.8651000000000004 0.7070488447736193 0.7070475542642082 9.671929241013288e-09 -0.09996686257738713 +2.8652 0.7070488631321998 0.7070475714932456 9.502861096979953e-09 -0.099966872642252 +2.8653000000000004 0.7070488814834096 0.7070475887188454 9.321708281141705e-09 -0.09996688270406037 +2.8654 0.7070488998271216 0.7070476059411387 9.128516258866126e-09 -0.09996689276281322 +2.8655 0.707048918163208 0.7070476231602555 8.923333255465848e-09 -0.09996690281851137 +2.8656 0.7070489364915424 0.7070476403763257 8.706210251861746e-09 -0.09996691287115576 +2.8657000000000004 0.7070489548119994 0.7070476575894789 8.477200968970422e-09 -0.09996692292074742 +2.8658 0.7070489731244529 0.7070476747998431 8.2363618520917e-09 -0.09996693296728715 +2.8659 0.7070489914287789 0.7070476920075466 7.983752055296112e-09 -0.09996694301077595 +2.866 0.707049009724853 0.707047709212717 7.719433437088086e-09 -0.09996695305121474 +2.8661000000000003 0.7070490280125519 0.7070477264154804 7.4434705335177376e-09 -0.09996696308860445 +2.8662 0.7070490462917528 0.7070477436159629 7.155930550374612e-09 -0.09996697312294595 +2.8663000000000003 0.7070490645623345 0.70704776081429 6.856883342371001e-09 -0.0999669831542403 +2.8664 0.7070490828241753 0.7070477780105855 6.546401397529433e-09 -0.0999669931824883 +2.8665 0.7070491010771551 0.7070477952049732 6.2245598250396106e-09 -0.09996700320769092 +2.8666000000000005 0.7070491193211544 0.7070478123975757 5.8914363301049155e-09 -0.09996701322984906 +2.8667000000000002 0.7070491375560548 0.707047829588515 5.5471111948604546e-09 -0.09996702324896369 +2.8668 0.7070491557817384 0.7070478467779118 5.1916672627605465e-09 -0.09996703326503564 +2.8669000000000002 0.7070491739980886 0.7070478639658861 4.825189916894679e-09 -0.09996704327806594 +2.867 0.7070491922049897 0.7070478811525573 4.4477670617729115e-09 -0.09996705328805544 +2.8671 0.7070492104023265 0.7070478983380432 4.059489098172386e-09 -0.09996706329500506 +2.8672000000000004 0.7070492285899856 0.7070479155224609 3.660448910126901e-09 -0.09996707329891581 +2.8673 0.7070492467678542 0.7070479327059267 3.250741829365078e-09 -0.09996708329978855 +2.8674 0.7070492649358202 0.7070479498885551 2.830465618830491e-09 -0.09996709329762415 +2.8675 0.7070492830937734 0.7070479670704606 2.399720457936516e-09 -0.09996710329242367 +2.8676000000000004 0.7070493012416038 0.7070479842517557 1.958608906137138e-09 -0.09996711328418795 +2.8677 0.7070493193792033 0.7070480014325522 1.5072358855797163e-09 -0.0999671232729179 +2.8678000000000003 0.7070493375064646 0.7070480186129606 1.0457086516146852e-09 -0.09996713325861448 +2.8679 0.7070493556232813 0.7070480357930902 5.741367728462343e-10 -0.09996714324127856 +2.868 0.7070493737295489 0.7070480529730491 9.263210250937126e-11 -0.09996715322091108 +2.8681000000000005 0.7070493918251635 0.7070480701529442 -3.9869125362246294e-10 -0.09996716319751298 +2.8682000000000003 0.7070494099100227 0.7070480873328813 -8.997169511151815e-10 -0.09996717317108517 +2.8683 0.7070494279840254 0.7070481045129646 -1.4103264502421387e-09 -0.09996718314162853 +2.8684000000000003 0.707049446047072 0.7070481216932976 -1.930399028994556e-09 -0.09996719310914406 +2.8685 0.7070494640990637 0.7070481388739815 -2.459811827316971e-09 -0.09996720307363266 +2.8686000000000003 0.7070494821399034 0.707048156055117 -2.998439857515578e-09 -0.09996721303509516 +2.8687000000000005 0.7070495001694954 0.7070481732368032 -3.5461560502283995e-09 -0.0999672229935326 +2.8688000000000002 0.7070495181877454 0.7070481904191376 -4.102831278711416e-09 -0.09996723294894584 +2.8689 0.7070495361945603 0.7070482076022164 -4.668334381389971e-09 -0.09996724290133582 +2.869 0.7070495541898485 0.7070482247861345 -5.242532206961581e-09 -0.0999672528507034 +2.8691000000000004 0.7070495721735202 0.7070482419709853 -5.825289630875807e-09 -0.0999672627970496 +2.8692 0.7070495901454863 0.7070482591568605 -6.416469601304431e-09 -0.09996727274037526 +2.8693 0.7070496081056598 0.7070482763438503 -7.0159331616928555e-09 -0.09996728268068122 +2.8694 0.7070496260539553 0.7070482935320441 -7.62353948632194e-09 -0.09996729261796856 +2.8695 0.7070496439902886 0.7070483107215286 -8.239145915869828e-09 -0.09996730255223811 +2.8696 0.707049661914577 0.7070483279123901 -8.862607986902249e-09 -0.09996731248349078 +2.8697000000000004 0.7070496798267398 0.7070483451047127 -9.493779466566987e-09 -0.09996732241172755 +2.8698 0.7070496977266977 0.7070483622985787 -1.0132512388155712e-08 -0.09996733233694927 +2.8699 0.7070497156143726 0.7070483794940692 -1.0778657087533172e-08 -0.09996734225915684 +2.87 0.7070497334896887 0.7070483966912637 -1.1432062232193813e-08 -0.09996735217835125 +2.8701000000000003 0.7070497513525715 0.70704841389024 -1.2092574865497224e-08 -0.09996736209453339 +2.8702 0.707049769202948 0.7070484310910738 -1.2760040429219549e-08 -0.09996737200770416 +2.8703000000000003 0.7070497870407473 0.7070484482938397 -1.343430281342678e-08 -0.0999673819178645 +2.8704 0.7070498048659 0.7070484654986102 -1.4115204386398739e-08 -0.09996739182501525 +2.8705 0.7070498226783379 0.7070484827054563 -1.4802586032792997e-08 -0.09996740172915736 +2.8706000000000005 0.7070498404779955 0.7070484999144474 -1.5496287190507746e-08 -0.09996741163029181 +2.8707000000000003 0.7070498582648082 0.7070485171256509 -1.6196145887978353e-08 -0.09996742152841943 +2.8708 0.7070498760387136 0.7070485343391324 -1.6901998781040234e-08 -0.09996743142354116 +2.8709000000000002 0.7070498937996512 0.7070485515549559 -1.761368119412854e-08 -0.09996744131565788 +2.871 0.7070499115475619 0.7070485687731837 -1.8331027151936852e-08 -0.09996745120477057 +2.8711 0.7070499292823883 0.7070485859938761 -1.9053869430157855e-08 -0.09996746109088009 +2.8712000000000004 0.7070499470040754 0.7070486032170915 -1.978203958150418e-08 -0.09996747097398738 +2.8713 0.7070499647125699 0.7070486204428872 -2.0515367983413302e-08 -0.09996748085409339 +2.8714 0.7070499824078197 0.7070486376713176 -2.1253683872742013e-08 -0.09996749073119898 +2.8715 0.707050000089775 0.7070486549024357 -2.1996815388267144e-08 -0.09996750060530504 +2.8716000000000004 0.7070500177583879 0.7070486721362931 -2.274458960884948e-08 -0.09996751047641252 +2.8717 0.7070500354136122 0.7070486893729386 -2.349683259506713e-08 -0.09996752034452229 +2.8718000000000004 0.707050053055404 0.7070487066124199 -2.4253369431716243e-08 -0.09996753020963527 +2.8719 0.7070500706837207 0.7070487238547827 -2.5014024261204443e-08 -0.09996754007175242 +2.872 0.7070500882985218 0.7070487411000702 -2.5778620333424124e-08 -0.09996754993087457 +2.8721000000000005 0.7070501058997689 0.7070487583483245 -2.6546980041314283e-08 -0.09996755978700267 +2.8722000000000003 0.7070501234874255 0.7070487755995858 -2.7318924961626523e-08 -0.0999675696401377 +2.8723 0.7070501410614567 0.7070487928538912 -2.809427590046154e-08 -0.09996757949028046 +2.8724000000000003 0.70705015862183 0.7070488101112771 -2.8872852930348844e-08 -0.09996758933743187 +2.8725 0.7070501761685145 0.7070488273717774 -2.9654475437084285e-08 -0.09996759918159293 +2.8726000000000003 0.7070501937014815 0.7070488446354243 -3.043896215550873e-08 -0.09996760902276451 +2.8727000000000005 0.7070502112207038 0.7070488619022477 -3.122613121677928e-08 -0.09996761886094746 +2.8728000000000002 0.7070502287261564 0.707048879172276 -3.2015800186316334e-08 -0.09996762869614273 +2.8729 0.7070502462178165 0.7070488964455351 -3.280778610890642e-08 -0.0999676385283512 +2.873 0.707050263695663 0.7070489137220493 -3.360190555098605e-08 -0.09996764835757374 +2.8731000000000004 0.7070502811596773 0.7070489310018409 -3.439797464184144e-08 -0.09996765818381136 +2.8732 0.7070502986098419 0.7070489482849301 -3.51958091161092e-08 -0.09996766800706493 +2.8733 0.7070503160461419 0.7070489655713352 -3.599522435887917e-08 -0.09996767782733533 +2.8734 0.707050333468564 0.7070489828610727 -3.679603544526778e-08 -0.09996768764462348 +2.8735 0.7070503508770976 0.7070490001541563 -3.759805718411141e-08 -0.09996769745893028 +2.8736 0.7070503682717328 0.7070490174505988 -3.840110416209342e-08 -0.09996770727025661 +2.8737000000000004 0.7070503856524633 0.7070490347504106 -3.920499078505224e-08 -0.09996771707860347 +2.8738 0.7070504030192837 0.7070490520535998 -4.000953132097e-08 -0.09996772688397168 +2.8739 0.7070504203721906 0.7070490693601726 -4.081453994458743e-08 -0.09996773668636214 +2.874 0.7070504377111833 0.7070490866701336 -4.161983077768201e-08 -0.09996774648577578 +2.8741000000000003 0.7070504550362626 0.707049103983485 -4.242521793414362e-08 -0.09996775628221356 +2.8742 0.7070504723474311 0.7070491213002268 -4.3230515560510195e-08 -0.09996776607567627 +2.8743000000000003 0.707050489644694 0.7070491386203575 -4.403553788378102e-08 -0.09996777586616486 +2.8744 0.707050506928058 0.7070491559438736 -4.4840099247398695e-08 -0.09996778565368025 +2.8745 0.7070505241975319 0.7070491732707694 -4.5644014159875596e-08 -0.09996779543822332 +2.8746000000000005 0.7070505414531267 0.7070491906010372 -4.644709733318819e-08 -0.099967805219795 +2.8747000000000003 0.707050558694855 0.7070492079346674 -4.7249163728747216e-08 -0.09996781499839619 +2.8748 0.7070505759227319 0.7070492252716483 -4.8050028598231424e-08 -0.09996782477402776 +2.8749000000000002 0.7070505931367737 0.7070492426119661 -4.8849507527470686e-08 -0.09996783454669056 +2.875 0.707050610337 0.7070492599556059 -4.9647416475477255e-08 -0.09996784431638567 +2.8751 0.7070506275234312 0.7070492773025496 -5.044357182307224e-08 -0.0999678540831139 +2.8752000000000004 0.7070506446960894 0.7070492946527778 -5.123779040763429e-08 -0.09996786384687609 +2.8753 0.7070506618550001 0.7070493120062689 -5.2029889571671845e-08 -0.09996787360767322 +2.8754 0.7070506790001895 0.7070493293629996 -5.2819687202179666e-08 -0.0999678833655061 +2.8755 0.7070506961316861 0.7070493467229444 -5.36070017716217e-08 -0.09996789312037573 +2.8756000000000004 0.7070507132495207 0.707049364086076 -5.439165237848022e-08 -0.09996790287228292 +2.8757 0.7070507303537257 0.7070493814523651 -5.517345879452705e-08 -0.09996791262122866 +2.8758000000000004 0.7070507474443352 0.7070493988217805 -5.595224150016856e-08 -0.09996792236721373 +2.8759 0.7070507645213857 0.7070494161942892 -5.672782172824742e-08 -0.09996793211023913 +2.876 0.7070507815849152 0.7070494335698561 -5.750002150502545e-08 -0.09996794185030572 +2.8761000000000005 0.7070507986349641 0.7070494509484441 -5.8268663689431746e-08 -0.09996795158741438 +2.8762000000000003 0.7070508156715741 0.7070494683300145 -5.903357201643075e-08 -0.09996796132156599 +2.8763 0.7070508326947896 0.7070494857145269 -5.979457113605355e-08 -0.0999679710527616 +2.8764000000000003 0.707050849704656 0.7070495031019386 -6.055148665373017e-08 -0.099967980781002 +2.8765 0.7070508667012207 0.7070495204922049 -6.130414516867036e-08 -0.09996799050628805 +2.8766000000000003 0.7070508836845337 0.7070495378852798 -6.205237431571378e-08 -0.09996800022862073 +2.8767000000000005 0.7070509006546457 0.7070495552811151 -6.279600280392761e-08 -0.09996800994800087 +2.8768000000000002 0.7070509176116101 0.7070495726796605 -6.353486045607148e-08 -0.09996801966442934 +2.8769 0.7070509345554821 0.7070495900808647 -6.426877824676144e-08 -0.09996802937790714 +2.877 0.7070509514863181 0.7070496074846739 -6.499758834150118e-08 -0.09996803908843511 +2.8771000000000004 0.7070509684041766 0.7070496248910326 -6.572112413614703e-08 -0.09996804879601412 +2.8772 0.707050985309118 0.707049642299884 -6.643922029246976e-08 -0.09996805850064505 +2.8773 0.7070510022012044 0.7070496597111688 -6.715171278022167e-08 -0.09996806820232887 +2.8774 0.7070510190804994 0.7070496771248269 -6.785843891009627e-08 -0.09996807790106642 +2.8775 0.7070510359470688 0.7070496945407956 -6.85592373710249e-08 -0.09996808759685863 +2.8776 0.7070510528009799 0.7070497119590109 -6.925394827050901e-08 -0.0999680972897064 +2.8777000000000004 0.7070510696423016 0.7070497293794069 -6.994241316801361e-08 -0.09996810697961062 +2.8778 0.7070510864711042 0.7070497468019165 -7.062447511529957e-08 -0.09996811666657215 +2.8779 0.7070511032874602 0.7070497642264701 -7.129997868678128e-08 -0.09996812635059192 +2.878 0.7070511200914437 0.707049781652997 -7.196877001465485e-08 -0.09996813603167078 +2.8781000000000003 0.7070511368831298 0.707049799081425 -7.263069683183243e-08 -0.09996814570980961 +2.8782 0.7070511536625962 0.7070498165116799 -7.328560849752946e-08 -0.09996815538500936 +2.8783000000000003 0.7070511704299214 0.7070498339436861 -7.393335603412751e-08 -0.0999681650572709 +2.8784 0.7070511871851858 0.7070498513773664 -7.457379216533819e-08 -0.09996817472659508 +2.8785 0.7070512039284718 0.7070498688126421 -7.520677134612713e-08 -0.09996818439298291 +2.8786000000000005 0.7070512206598621 0.7070498862494325 -7.583214979524008e-08 -0.09996819405643517 +2.8787000000000003 0.7070512373794422 0.7070499036876563 -7.644978552816262e-08 -0.09996820371695275 +2.8788 0.7070512540872985 0.70704992112723 -7.70595383900799e-08 -0.09996821337453665 +2.8789000000000002 0.7070512707835189 0.7070499385680686 -7.76612700892701e-08 -0.09996822302918766 +2.879 0.7070512874681929 0.707049956010086 -7.825484422616102e-08 -0.09996823268090671 +2.8791 0.7070513041414115 0.7070499734531945 -7.884012632412146e-08 -0.09996824232969469 +2.8792000000000004 0.7070513208032667 0.7070499908973047 -7.941698385895146e-08 -0.09996825197555248 +2.8793 0.7070513374538524 0.707050008342326 -7.99852862918421e-08 -0.09996826161848094 +2.8794 0.7070513540932635 0.7070500257881667 -8.054490509799839e-08 -0.09996827125848096 +2.8795 0.7070513707215966 0.7070500432347336 -8.109571379526226e-08 -0.09996828089555351 +2.8796000000000004 0.7070513873389496 0.7070500606819317 -8.163758797013337e-08 -0.09996829052969941 +2.8797 0.7070514039454211 0.7070500781296654 -8.217040531159625e-08 -0.09996830016091954 +2.8798000000000004 0.7070514205411118 0.7070500955778375 -8.269404563453903e-08 -0.09996830978921484 +2.8799 0.7070514371261236 0.7070501130263492 -8.320839090490695e-08 -0.09996831941458617 +2.88 0.7070514537005586 0.7070501304751009 -8.37133252752642e-08 -0.09996832903703433 +2.8801000000000005 0.7070514702645214 0.7070501479239921 -8.420873509693699e-08 -0.09996833865656038 +2.8802000000000003 0.7070514868181174 0.7070501653729202 -8.46945089564427e-08 -0.09996834827316513 +2.8803 0.7070515033614527 0.707050182821782 -8.517053770064342e-08 -0.09996835788684943 +2.8804000000000003 0.707051519894635 0.7070502002704733 -8.563671445496052e-08 -0.09996836749761424 +2.8805 0.7070515364177729 0.7070502177188882 -8.609293465113022e-08 -0.0999683771054604 +2.8806000000000003 0.7070515529309762 0.7070502351669201 -8.653909604888765e-08 -0.09996838671038877 +2.8807000000000005 0.7070515694343563 0.7070502526144613 -8.6975098760253e-08 -0.09996839631240031 +2.8808000000000002 0.7070515859280244 0.707050270061403 -8.74008452712155e-08 -0.0999684059114958 +2.8809 0.7070516024120936 0.7070502875076354 -8.78162404660196e-08 -0.09996841550767621 +2.881 0.707051618886678 0.7070503049530479 -8.822119164277747e-08 -0.09996842510094239 +2.8811000000000004 0.7070516353518923 0.7070503223975284 -8.861560854035722e-08 -0.09996843469129524 +2.8812 0.7070516518078525 0.7070503398409644 -8.899940335139328e-08 -0.0999684442787356 +2.8813 0.7070516682546749 0.7070503572832423 -8.937249074743997e-08 -0.09996845386326438 +2.8814 0.7070516846924779 0.7070503747242478 -8.973478789892075e-08 -0.09996846344488255 +2.8815 0.7070517011213794 0.7070503921638654 -9.008621449160814e-08 -0.09996847302359092 +2.8816 0.7070517175414988 0.707050409601979 -9.042669273789938e-08 -0.09996848259939038 +2.8817000000000004 0.7070517339529561 0.7070504270384714 -9.07561474080415e-08 -0.09996849217228178 +2.8818 0.7070517503558722 0.7070504444732248 -9.107450583360072e-08 -0.099968501742266 +2.8819 0.7070517667503688 0.7070504619061209 -9.13816979274118e-08 -0.09996851130934395 +2.882 0.7070517831365686 0.7070504793370405 -9.167765619919055e-08 -0.09996852087351654 +2.8821000000000003 0.7070517995145944 0.7070504967658635 -9.196231578068731e-08 -0.09996853043478467 +2.8822 0.7070518158845697 0.7070505141924693 -9.223561441701333e-08 -0.09996853999314913 +2.8823000000000003 0.707051832246619 0.7070505316167368 -9.249749250133527e-08 -0.09996854954861085 +2.8824 0.7070518486008672 0.7070505490385443 -9.274789307921194e-08 -0.09996855910117072 +2.8825 0.7070518649474399 0.7070505664577691 -9.298676185813537e-08 -0.09996856865082959 +2.8826000000000005 0.707051881286463 0.7070505838742882 -9.321404722748006e-08 -0.09996857819758836 +2.8827000000000003 0.7070518976180638 0.7070506012879783 -9.342970026023772e-08 -0.09996858774144796 +2.8828 0.7070519139423685 0.7070506186987155 -9.363367472862982e-08 -0.09996859728240923 +2.8829000000000002 0.707051930259505 0.7070506361063751 -9.382592711711796e-08 -0.09996860682047298 +2.883 0.7070519465696015 0.7070506535108325 -9.400641662934278e-08 -0.09996861635564024 +2.8831 0.7070519628727859 0.7070506709119623 -9.417510518985872e-08 -0.09996862588791176 +2.8832000000000004 0.7070519791691872 0.7070506883096386 -9.433195745801176e-08 -0.0999686354172884 +2.8833 0.7070519954589347 0.7070507057037358 -9.447694084008251e-08 -0.09996864494377118 +2.8834 0.7070520117421575 0.7070507230941276 -9.46100254849494e-08 -0.09996865446736088 +2.8835 0.7070520280189855 0.7070507404806872 -9.473118429796645e-08 -0.09996866398805837 +2.8836000000000004 0.7070520442895487 0.7070507578632874 -9.484039294530011e-08 -0.09996867350586458 +2.8837 0.7070520605539774 0.7070507752418016 -9.493762985653131e-08 -0.09996868302078034 +2.8838000000000004 0.7070520768124016 0.7070507926161023 -9.502287623072703e-08 -0.09996869253280655 +2.8839 0.7070520930649522 0.707050809986062 -9.509611603904233e-08 -0.09996870204194407 +2.884 0.7070521093117599 0.7070508273515534 -9.515733602385307e-08 -0.09996871154819384 +2.8841000000000006 0.7070521255529554 0.7070508447124485 -9.520652571089888e-08 -0.09996872105155667 +2.8842000000000003 0.7070521417886694 0.7070508620686198 -9.524367740234435e-08 -0.09996873055203348 +2.8843 0.7070521580190331 0.7070508794199395 -9.526878618111578e-08 -0.09996874004962515 +2.8844000000000003 0.7070521742441772 0.7070508967662794 -9.528184991090122e-08 -0.09996874954433249 +2.8845 0.7070521904642326 0.7070509141075119 -9.528286923094625e-08 -0.09996875903615639 +2.8846000000000003 0.7070522066793308 0.707050931443509 -9.527184756559504e-08 -0.09996876852509781 +2.8847000000000005 0.7070522228896017 0.7070509487741432 -9.524879110867773e-08 -0.09996877801115751 +2.8848000000000003 0.7070522390951766 0.7070509660992867 -9.521370883478625e-08 -0.09996878749433641 +2.8849 0.7070522552961862 0.7070509834188121 -9.516661248626379e-08 -0.09996879697463544 +2.885 0.7070522714927606 0.7070510007325922 -9.510751658014377e-08 -0.09996880645205544 +2.8851000000000004 0.70705228768503 0.7070510180404996 -9.503643839253728e-08 -0.09996881592659723 +2.8852 0.7070523038731245 0.7070510353424074 -9.495339796036784e-08 -0.0999688253982617 +2.8853 0.7070523200571741 0.7070510526381892 -9.485841807009565e-08 -0.09996883486704981 +2.8854 0.7070523362373082 0.7070510699277184 -9.475152425945238e-08 -0.09996884433296238 +2.8855 0.7070523524136557 0.7070510872108688 -9.463274481223694e-08 -0.09996885379600025 +2.8856 0.7070523685863459 0.7070511044875151 -9.450211074270298e-08 -0.09996886325616437 +2.8857000000000004 0.707052384755507 0.7070511217575314 -9.435965578775268e-08 -0.09996887271345556 +2.8858 0.7070524009212669 0.7070511390207929 -9.420541640173252e-08 -0.09996888216787468 +2.8859 0.7070524170837535 0.7070511562771751 -9.403943175122914e-08 -0.09996889161942261 +2.886 0.7070524332430939 0.7070511735265537 -9.386174369945682e-08 -0.09996890106810025 +2.8861000000000003 0.7070524493994146 0.7070511907688052 -9.367239679584916e-08 -0.0999689105139084 +2.8862 0.7070524655528423 0.7070512080038065 -9.34714382630486e-08 -0.09996891995684802 +2.8863000000000003 0.7070524817035021 0.7070512252314349 -9.32589179969065e-08 -0.0999689293969199 +2.8864 0.7070524978515194 0.7070512424515686 -9.303488853872749e-08 -0.09996893883412494 +2.8865 0.7070525139970187 0.7070512596640859 -9.279940507266743e-08 -0.09996894826846403 +2.8866000000000005 0.7070525301401238 0.7070512768688664 -9.255252540404935e-08 -0.09996895769993804 +2.8867000000000003 0.707052546280958 0.7070512940657898 -9.229430995676136e-08 -0.0999689671285479 +2.8868 0.7070525624196438 0.7070513112547365 -9.202482174550108e-08 -0.09996897655429436 +2.8869000000000002 0.707052578556303 0.707051328435588 -9.174412637664303e-08 -0.09996898597717839 +2.887 0.7070525946910566 0.7070513456082261 -9.145229200833993e-08 -0.09996899539720078 +2.8871 0.707052610824025 0.7070513627725337 -9.114938936266581e-08 -0.09996900481436244 +2.8872000000000004 0.7070526269553277 0.7070513799283942 -9.083549168224792e-08 -0.09996901422866421 +2.8873 0.7070526430850833 0.7070513970756922 -9.051067473113406e-08 -0.09996902364010701 +2.8874 0.7070526592134097 0.7070514142143125 -9.01750167679044e-08 -0.09996903304869162 +2.8875 0.7070526753404239 0.7070514313441416 -8.982859852832425e-08 -0.099969042454419 +2.8876000000000004 0.7070526914662422 0.7070514484650661 -8.947150320626207e-08 -0.09996905185728994 +2.8877 0.7070527075909794 0.7070514655769741 -8.91038164328728e-08 -0.09996906125730537 +2.8878000000000004 0.7070527237147497 0.7070514826797545 -8.87256262575159e-08 -0.09996907065446607 +2.8879 0.7070527398376669 0.7070514997732973 -8.833702312867342e-08 -0.09996908004877308 +2.888 0.707052755959843 0.7070515168574929 -8.793809986619439e-08 -0.09996908944022712 +2.8881000000000006 0.7070527720813888 0.7070515339322335 -8.752895164828439e-08 -0.0999690988288291 +2.8882000000000003 0.7070527882024151 0.707051550997412 -8.710967597681113e-08 -0.09996910821457988 +2.8883 0.7070528043230304 0.7070515680529221 -8.668037266949813e-08 -0.09996911759748034 +2.8884000000000003 0.7070528204433428 0.7070515850986587 -8.624114381655668e-08 -0.09996912697753127 +2.8885 0.7070528365634594 0.7070516021345187 -8.579209377548164e-08 -0.09996913635473362 +2.8886000000000003 0.7070528526834858 0.7070516191603989 -8.533332913375491e-08 -0.09996914572908824 +2.8887000000000005 0.7070528688035265 0.7070516361761979 -8.486495869063082e-08 -0.09996915510059595 +2.8888000000000003 0.7070528849236848 0.7070516531818156 -8.438709342938056e-08 -0.09996916446925767 +2.8889 0.7070529010440629 0.707051670177153 -8.389984648259768e-08 -0.09996917383507425 +2.889 0.7070529171647615 0.707051687162112 -8.340333312265719e-08 -0.09996918319804651 +2.8891000000000004 0.7070529332858805 0.707051704136596 -8.289767072094945e-08 -0.09996919255817534 +2.8892 0.7070529494075182 0.7070517211005101 -8.238297872359412e-08 -0.09996920191546166 +2.8893 0.7070529655297716 0.7070517380537601 -8.185937862368459e-08 -0.09996921126990632 +2.8894 0.7070529816527362 0.7070517549962534 -8.132699393700177e-08 -0.0999692206215101 +2.8895 0.7070529977765065 0.707051771927899 -8.078595016558499e-08 -0.09996922997027402 +2.8896 0.7070530139011753 0.7070517888486064 -8.023637477084372e-08 -0.09996923931619872 +2.8897000000000004 0.7070530300268341 0.7070518057582875 -7.96783971423326e-08 -0.0999692486592852 +2.8898 0.7070530461535733 0.7070518226568552 -7.911214857173055e-08 -0.0999692579995343 +2.8899 0.7070530622814816 0.7070518395442235 -7.853776222074837e-08 -0.09996926733694687 +2.89 0.7070530784106459 0.7070518564203084 -7.795537308383227e-08 -0.09996927667152378 +2.8901000000000003 0.7070530945411522 0.7070518732850272 -7.736511796301027e-08 -0.09996928600326582 +2.8902 0.707053110673085 0.7070518901382986 -7.67671354375346e-08 -0.099969295332174 +2.8903000000000003 0.7070531268065268 0.7070519069800429 -7.616156582051364e-08 -0.09996930465824905 +2.8904 0.707053142941559 0.7070519238101817 -7.554855113549308e-08 -0.09996931398149186 +2.8905 0.7070531590782616 0.7070519406286386 -7.492823508132782e-08 -0.0999693233019034 +2.8906000000000005 0.7070531752167124 0.7070519574353387 -7.430076299835484e-08 -0.09996933261948444 +2.8907000000000003 0.7070531913569879 0.7070519742302078 -7.366628183369875e-08 -0.0999693419342358 +2.8908 0.7070532074991631 0.7070519910131745 -7.30249401091794e-08 -0.09996935124615841 +2.8909000000000002 0.7070532236433117 0.7070520077841682 -7.237688788097954e-08 -0.0999693605552531 +2.891 0.707053239789505 0.7070520245431202 -7.172227670841982e-08 -0.09996936986152066 +2.8911000000000002 0.7070532559378131 0.7070520412899635 -7.106125962013168e-08 -0.09996937916496203 +2.8912000000000004 0.7070532720883049 0.7070520580246329 -7.039399107589342e-08 -0.09996938846557811 +2.8913 0.7070532882410465 0.7070520747470648 -6.972062692933365e-08 -0.09996939776336965 +2.8914 0.7070533043961031 0.7070520914571966 -6.904132439410418e-08 -0.09996940705833754 +2.8915 0.7070533205535385 0.7070521081549687 -6.835624200614981e-08 -0.09996941635048273 +2.8916000000000004 0.7070533367134136 0.7070521248403221 -6.766553958771279e-08 -0.09996942563980592 +2.8917 0.7070533528757889 0.7070521415132 -6.69693782091689e-08 -0.09996943492630805 +2.8918000000000004 0.7070533690407221 0.7070521581735474 -6.626792014869515e-08 -0.09996944420999002 +2.8919 0.7070533852082701 0.7070521748213111 -6.556132886277946e-08 -0.09996945349085269 +2.892 0.707053401378487 0.7070521914564392 -6.484976893764843e-08 -0.09996946276889682 +2.8921000000000006 0.7070534175514259 0.7070522080788819 -6.413340605717494e-08 -0.09996947204412332 +2.8922000000000003 0.7070534337271378 0.7070522246885913 -6.34124069668826e-08 -0.09996948131653305 +2.8923 0.7070534499056719 0.7070522412855211 -6.268693942493991e-08 -0.09996949058612684 +2.8924000000000003 0.7070534660870755 0.707052257869627 -6.19571721739709e-08 -0.09996949985290554 +2.8925 0.7070534822713943 0.7070522744408667 -6.122327489812077e-08 -0.09996950911687007 +2.8926000000000003 0.707053498458672 0.707052290999199 -6.04854181796878e-08 -0.0999695183780212 +2.8927000000000005 0.7070535146489505 0.7070523075445849 -5.974377346442891e-08 -0.09996952763635979 +2.8928000000000003 0.70705353084227 0.707052324076988 -5.899851302014307e-08 -0.09996953689188676 +2.8929 0.7070535470386685 0.7070523405963728 -5.824980989742323e-08 -0.0999695461446029 +2.893 0.7070535632381825 0.7070523571027059 -5.7497837886721914e-08 -0.09996955539450914 +2.8931000000000004 0.7070535794408463 0.7070523735959559 -5.674277148127148e-08 -0.09996956464160626 +2.8932 0.7070535956466928 0.7070523900760934 -5.598478583501709e-08 -0.09996957388589517 +2.8933 0.7070536118557523 0.7070524065430905 -5.5224056721633885e-08 -0.09996958312737668 +2.8934 0.7070536280680537 0.7070524229969215 -5.446076049484515e-08 -0.09996959236605163 +2.8935 0.7070536442836242 0.7070524394375626 -5.3695074049391056e-08 -0.09996960160192092 +2.8936 0.7070536605024884 0.7070524558649919 -5.2927174773974295e-08 -0.09996961083498539 +2.8937000000000004 0.7070536767246693 0.7070524722791891 -5.215724051699927e-08 -0.09996962006524585 +2.8938 0.7070536929501883 0.7070524886801364 -5.138544954081878e-08 -0.0999696292927032 +2.8939 0.7070537091790645 0.7070525050678174 -5.0611980481618524e-08 -0.09996963851735828 +2.894 0.7070537254113154 0.7070525214422174 -4.983701231060268e-08 -0.09996964773921191 +2.8941000000000003 0.707053741646956 0.7070525378033247 -4.906072428921635e-08 -0.09996965695826494 +2.8942 0.7070537578859999 0.7070525541511286 -4.828329592913849e-08 -0.09996966617451825 +2.8943000000000003 0.7070537741284589 0.7070525704856205 -4.750490695119066e-08 -0.09996967538797273 +2.8944 0.7070537903743421 0.7070525868067938 -4.67257372423484e-08 -0.09996968459862911 +2.8945 0.7070538066236578 0.7070526031146444 -4.594596681665574e-08 -0.0999696938064884 +2.8946000000000005 0.7070538228764112 0.7070526194091689 -4.516577576936347e-08 -0.09996970301155132 +2.8947000000000003 0.7070538391326062 0.7070526356903666 -4.438534424188226e-08 -0.09996971221381878 +2.8948 0.7070538553922447 0.707052651958239 -4.3604852373752565e-08 -0.09996972141329163 +2.8949000000000003 0.7070538716553267 0.7070526682127891 -4.282448026429091e-08 -0.09996973060997066 +2.895 0.7070538879218498 0.7070526844540216 -4.2044407930116314e-08 -0.09996973980385676 +2.8951000000000002 0.7070539041918102 0.7070527006819436 -4.1264815265793734e-08 -0.09996974899495076 +2.8952000000000004 0.7070539204652025 0.7070527168965642 -4.0485881998189154e-08 -0.09996975818325354 +2.8953 0.7070539367420182 0.7070527330978941 -3.97077876500675e-08 -0.09996976736876592 +2.8954 0.7070539530222479 0.707052749285946 -3.8930711494637466e-08 -0.09996977655148874 +2.8955 0.7070539693058798 0.7070527654607346 -3.815483251546313e-08 -0.09996978573142289 +2.8956000000000004 0.7070539855929003 0.7070527816222765 -3.738032936602322e-08 -0.09996979490856914 +2.8957 0.7070540018832943 0.7070527977705898 -3.660738032769829e-08 -0.0999698040829284 +2.8958000000000004 0.7070540181770438 0.7070528139056956 -3.5836163271660976e-08 -0.09996981325450152 +2.8959 0.7070540344741298 0.7070528300276159 -3.5066855612526406e-08 -0.09996982242328933 +2.896 0.7070540507745313 0.7070528461363748 -3.4299634271706125e-08 -0.09996983158929267 +2.8961000000000006 0.7070540670782246 0.7070528622319985 -3.353467563534107e-08 -0.09996984075251236 +2.8962000000000003 0.7070540833851853 0.707052878314515 -3.2772155513210305e-08 -0.09996984991294935 +2.8963 0.707054099695386 0.7070528943839542 -3.2012249100024995e-08 -0.09996985907060436 +2.8964000000000003 0.7070541160087982 0.7070529104403476 -3.1255130934337155e-08 -0.09996986822547826 +2.8965 0.7070541323253916 0.7070529264837291 -3.0500974858641006e-08 -0.09996987737757199 +2.8966000000000003 0.7070541486451333 0.7070529425141341 -2.9749953978173288e-08 -0.09996988652688626 +2.8967 0.7070541649679889 0.7070529585315997 -2.9002240624050393e-08 -0.09996989567342197 +2.8968000000000003 0.7070541812939223 0.7070529745361654 -2.8258006310333955e-08 -0.09996990481717999 +2.8969 0.7070541976228957 0.707052990527872 -2.7517421696083774e-08 -0.09996991395816113 +2.897 0.7070542139548692 0.7070530065067621 -2.67806565471939e-08 -0.09996992309636625 +2.8971000000000005 0.707054230289801 0.7070530224728806 -2.6047879696927678e-08 -0.09996993223179618 +2.8972 0.7070542466276478 0.7070530384262741 -2.5319259007536982e-08 -0.0999699413644518 +2.8973 0.7070542629683645 0.7070530543669906 -2.4594961331014104e-08 -0.09996995049433392 +2.8974 0.7070542793119039 0.7070530702950799 -2.3875152470494154e-08 -0.09996995962144337 +2.8975 0.7070542956582173 0.7070530862105939 -2.3159997144910072e-08 -0.09996996874578103 +2.8976 0.7070543120072541 0.7070531021135862 -2.2449658945624534e-08 -0.09996997786734771 +2.8977000000000004 0.7070543283589621 0.707053118004112 -2.1744300306939662e-08 -0.09996998698614426 +2.8978 0.7070543447132869 0.7070531338822281 -2.1044082463596292e-08 -0.0999699961021715 +2.8979 0.7070543610701732 0.7070531497479935 -2.0349165414778464e-08 -0.09997000521543027 +2.898 0.7070543774295635 0.7070531656014685 -1.9659707889418954e-08 -0.09997001432592144 +2.8981000000000003 0.7070543937913987 0.7070531814427148 -1.8975867307601674e-08 -0.09997002343364586 +2.8982 0.7070544101556181 0.707053197271797 -1.82977997436988e-08 -0.09997003253860437 +2.8983000000000003 0.707054426522159 0.7070532130887799 -1.7625659896880475e-08 -0.09997004164079776 +2.8984 0.7070544428909573 0.7070532288937306 -1.6959601049481438e-08 -0.09997005074022691 +2.8985 0.7070544592619474 0.707053244686718 -1.6299775034908648e-08 -0.09997005983689265 +2.8986000000000005 0.7070544756350621 0.7070532604678126 -1.5646332201212088e-08 -0.09997006893079587 +2.8987000000000003 0.7070544920102322 0.7070532762370859 -1.4999421378125016e-08 -0.09997007802193732 +2.8988 0.7070545083873871 0.7070532919946115 -1.4359189844971587e-08 -0.09997008711031788 +2.8989000000000003 0.7070545247664551 0.7070533077404646 -1.3725783292069249e-08 -0.0999700961959384 +2.899 0.7070545411473623 0.7070533234747216 -1.309934579253949e-08 -0.09997010527879968 +2.8991000000000002 0.7070545575300334 0.7070533391974605 -1.2480019770649137e-08 -0.09997011435890256 +2.8992000000000004 0.7070545739143923 0.7070533549087612 -1.1867945961911708e-08 -0.09997012343624795 +2.8993 0.7070545903003602 0.7070533706087048 -1.1263263386199207e-08 -0.0999701325108366 +2.8994 0.7070546066878578 0.7070533862973736 -1.0666109321287587e-08 -0.09997014158266936 +2.8995 0.7070546230768039 0.7070534019748519 -1.0076619261223385e-08 -0.09997015065174708 +2.8996000000000004 0.7070546394671162 0.7070534176412252 -9.494926889869193e-09 -0.09997015971807063 +2.8997 0.7070546558587105 0.7070534332965801 -8.921164056617525e-09 -0.0999701687816408 +2.8998000000000004 0.7070546722515016 0.7070534489410053 -8.355460733890097e-09 -0.09997017784245846 +2.8999 0.7070546886454032 0.7070534645745903 -7.797945001525308e-09 -0.09997018690052448 +2.9 0.7070547050403266 0.707053480197426 -7.248743013818504e-09 -0.09997019595583964 +2.9001000000000006 0.7070547214361829 0.7070534958096046 -6.707978957888605e-09 -0.09997020500840476 +2.9002000000000003 0.7070547378328809 0.7070535114112202 -6.175775043269771e-09 -0.09997021405822071 +2.9003 0.7070547542303293 0.7070535270023672 -5.652251467216929e-09 -0.09997022310528832 +2.9004000000000003 0.7070547706284341 0.707053542583142 -5.137526388684921e-09 -0.09997023214960837 +2.9005 0.7070547870271013 0.7070535581536421 -4.63171589536876e-09 -0.09997024119118175 +2.9006000000000003 0.7070548034262353 0.7070535737139663 -4.134933988091116e-09 -0.09997025023000933 +2.9007 0.7070548198257389 0.7070535892642141 -3.64729254610785e-09 -0.0999702592660919 +2.9008000000000003 0.7070548362255141 0.7070536048044865 -3.168901311495498e-09 -0.09997026829943023 +2.9009 0.7070548526254616 0.7070536203348861 -2.6998678509873586e-09 -0.09997027733002524 +2.901 0.7070548690254814 0.7070536358555158 -2.240297544697789e-09 -0.09997028635787776 +2.9011000000000005 0.7070548854254713 0.7070536513664802 -1.7902935601013525e-09 -0.09997029538298854 +2.9012000000000002 0.7070549018253295 0.707053666867885 -1.3499568190730726e-09 -0.09997030440535852 +2.9013 0.7070549182249521 0.7070536823598366 -9.193859866127307e-10 -0.09997031342498852 +2.9014 0.7070549346242344 0.7070536978424424 -4.986774448240139e-10 -0.09997032244187931 +2.9015 0.7070549510230708 0.707053713315811 -8.792527036310949e-11 -0.09997033145603172 +2.9016 0.707054967421355 0.7070537287800522 3.127787889800615e-10 -0.09997034046744668 +2.9017000000000004 0.7070549838189789 0.7070537442352764 7.033453281596325e-10 -0.09997034947612493 +2.9018 0.7070550002158341 0.7070537596815953 1.0836873100272815e-09 -0.09997035848206731 +2.9019 0.7070550166118111 0.7070537751191208 1.4537200809447426e-09 -0.09997036748527464 +2.902 0.7070550330068001 0.7070537905479666 1.8133613950699345e-09 -0.09997037648574784 +2.9021000000000003 0.7070550494006894 0.7070538059682463 2.162531426500025e-09 -0.09997038548348762 +2.9022 0.7070550657933672 0.7070538213800749 2.5011527874860273e-09 -0.09997039447849485 +2.9023000000000003 0.707055082184721 0.7070538367835684 2.8291505527189287e-09 -0.09997040347077041 +2.9024 0.7070550985746369 0.7070538521788432 3.1464522662685845e-09 -0.09997041246031509 +2.9025 0.7070551149630004 0.7070538675660163 3.4529879650024853e-09 -0.09997042144712964 +2.9026000000000005 0.707055131349697 0.707053882945206 3.748690186392012e-09 -0.09997043043121503 +2.9027000000000003 0.707055147734611 0.7070538983165309 4.033493994533288e-09 -0.09997043941257208 +2.9028 0.7070551641176255 0.7070539136801101 4.307336986218713e-09 -0.09997044839120153 +2.9029000000000003 0.7070551804986237 0.7070539290360636 4.570159302212662e-09 -0.09997045736710425 +2.903 0.7070551968774882 0.7070539443845122 4.821903648935533e-09 -0.09997046634028106 +2.9031000000000002 0.7070552132541004 0.7070539597255768 5.06251530193319e-09 -0.09997047531073278 +2.9032000000000004 0.7070552296283416 0.7070539750593792 5.291942125826288e-09 -0.09997048427846023 +2.9033 0.7070552460000927 0.7070539903860418 5.510134579514436e-09 -0.09997049324346431 +2.9034 0.7070552623692337 0.7070540057056871 5.717045731788717e-09 -0.09997050220574577 +2.9035 0.7070552787356446 0.7070540210184382 5.912631263933765e-09 -0.09997051116530546 +2.9036000000000004 0.7070552950992042 0.7070540363244192 6.096849485340283e-09 -0.09997052012214419 +2.9037 0.7070553114597917 0.7070540516237536 6.26966134391338e-09 -0.09997052907626279 +2.9038000000000004 0.7070553278172855 0.7070540669165662 6.431030427807294e-09 -0.0999705380276621 +2.9039 0.7070553441715637 0.7070540822029816 6.58092297756846e-09 -0.09997054697634294 +2.904 0.7070553605225043 0.7070540974831252 6.7193078913396764e-09 -0.09997055592230616 +2.9041000000000006 0.7070553768699845 0.7070541127571224 6.846156732666364e-09 -0.09997056486555257 +2.9042000000000003 0.7070553932138817 0.7070541280250984 6.961443735700734e-09 -0.09997057380608296 +2.9043 0.7070554095540729 0.7070541432871797 7.0651458104059595e-09 -0.0999705827438982 +2.9044 0.7070554258904347 0.7070541585434925 7.1572425434235365e-09 -0.09997059167899913 +2.9045 0.7070554422228434 0.7070541737941627 7.237716211083711e-09 -0.09997060061138649 +2.9046000000000003 0.7070554585511758 0.707054189039317 7.3065517715992234e-09 -0.09997060954106113 +2.9047 0.7070554748753084 0.7070542042790824 7.363736875473648e-09 -0.09997061846802396 +2.9048000000000003 0.707055491195117 0.7070542195135849 7.409261865501393e-09 -0.09997062739227575 +2.9049 0.7070555075104776 0.707054234742952 7.443119775900342e-09 -0.09997063631381728 +2.905 0.7070555238212667 0.7070542499673101 7.465306334913935e-09 -0.09997064523264941 +2.9051000000000005 0.7070555401273599 0.7070542651867863 7.475819966545894e-09 -0.09997065414877297 +2.9052000000000002 0.7070555564286336 0.7070542804015072 7.474661787090775e-09 -0.09997066306218874 +2.9053 0.7070555727249636 0.7070542956115995 7.461835607736056e-09 -0.09997067197289755 +2.9054 0.7070555890162264 0.7070543108171905 7.437347930225324e-09 -0.09997068088090028 +2.9055 0.7070556053022983 0.7070543260184063 7.4012079373173e-09 -0.09997068978619775 +2.9056 0.7070556215830557 0.7070543412153736 7.353427509265709e-09 -0.09997069868879072 +2.9057000000000004 0.7070556378583752 0.7070543564082188 7.29402120386996e-09 -0.0999707075886801 +2.9058 0.7070556541281333 0.7070543715970676 7.223006256475151e-09 -0.0999707164858666 +2.9059 0.7070556703922071 0.7070543867820465 7.140402573033167e-09 -0.09997072538035111 +2.906 0.707055686650474 0.7070544019632806 7.0462327353068566e-09 -0.0999707342721344 +2.9061000000000003 0.7070557029028115 0.7070544171408957 6.940521977451264e-09 -0.09997074316121735 +2.9062 0.7070557191490969 0.7070544323150167 6.823298190350435e-09 -0.09997075204760072 +2.9063000000000003 0.7070557353892091 0.7070544474857681 6.694591920750059e-09 -0.09997076093128533 +2.9064 0.7070557516230263 0.7070544626532747 6.554436346103976e-09 -0.0999707698122721 +2.9065 0.7070557678504273 0.7070544778176603 6.402867282380431e-09 -0.09997077869056173 +2.9066000000000005 0.7070557840712917 0.7070544929790484 6.239923162378036e-09 -0.09997078756615509 +2.9067000000000003 0.707055800285499 0.7070545081375623 6.065645034858402e-09 -0.099970796439053 +2.9068 0.7070558164929297 0.707054523293325 5.8800765524030796e-09 -0.09997080530925634 +2.9069000000000003 0.7070558326934643 0.7070545384464582 5.683263951464235e-09 -0.09997081417676584 +2.907 0.707055848886984 0.7070545535970834 5.475256060170908e-09 -0.09997082304158231 +2.9071000000000002 0.7070558650733709 0.707054568745322 5.2561042697060745e-09 -0.09997083190370666 +2.9072000000000005 0.7070558812525073 0.7070545838912943 5.025862528235114e-09 -0.09997084076313961 +2.9073 0.707055897424276 0.7070545990351202 4.784587323558576e-09 -0.09997084961988201 +2.9074 0.7070559135885607 0.707054614176919 4.532337677040643e-09 -0.09997085847393467 +2.9075 0.707055929745246 0.7070546293168092 4.269175116720925e-09 -0.09997086732529842 +2.9076000000000004 0.7070559458942167 0.7070546444549086 3.995163676447089e-09 -0.09997087617397407 +2.9077 0.7070559620353585 0.7070546595913347 3.71036986811929e-09 -0.09997088501996246 +2.9078000000000004 0.7070559781685581 0.7070546747262038 3.414862676485997e-09 -0.09997089386326438 +2.9079 0.7070559942937026 0.7070546898596312 3.10871353225578e-09 -0.09997090270388063 +2.908 0.70705601041068 0.7070547049917318 2.7919963103625878e-09 -0.09997091154181206 +2.9081000000000006 0.7070560265193792 0.70705472012262 2.4647872891997435e-09 -0.09997092037705947 +2.9082000000000003 0.7070560426196901 0.707054735252409 2.1271651445484152e-09 -0.09997092920962375 +2.9083 0.7070560587115028 0.7070547503812108 1.7792109443734438e-09 -0.09997093803950559 +2.9084 0.707056074794709 0.7070547655091368 1.4210081037205335e-09 -0.09997094686670582 +2.9085 0.7070560908692014 0.7070547806362975 1.0526423821141662e-09 -0.09997095569122534 +2.9086000000000003 0.7070561069348731 0.7070547957628026 6.742018592714727e-10 -0.09997096451306492 +2.9087 0.7070561229916185 0.7070548108887602 2.8577690561193414e-10 -0.09997097333222531 +2.9088000000000003 0.7070561390393328 0.7070548260142783 -1.125398255488741e-10 -0.09997098214870744 +2.9089 0.7070561550779126 0.7070548411394633 -5.206534300916665e-10 -0.09997099096251205 +2.909 0.7070561711072552 0.7070548562644204 -9.384667669712354e-10 -0.09997099977363993 +2.9091000000000005 0.7070561871272588 0.7070548713892542 -1.365880493778282e-09 -0.09997100858209193 +2.9092000000000002 0.7070562031378236 0.7070548865140682 -1.8027930762803956e-09 -0.09997101738786891 +2.9093 0.7070562191388496 0.7070549016389645 -2.2491008291880554e-09 -0.09997102619097159 +2.9094 0.7070562351302389 0.7070549167640439 -2.704697920491439e-09 -0.09997103499140081 +2.9095 0.7070562511118946 0.7070549318894064 -3.169476413093786e-09 -0.09997104378915743 +2.9096 0.7070562670837208 0.707054947015151 -3.6433262812912703e-09 -0.09997105258424228 +2.9097000000000004 0.7070562830456228 0.7070549621413749 -4.1261354454674715e-09 -0.09997106137665608 +2.9098 0.7070562989975075 0.7070549772681742 -4.617789782501713e-09 -0.09997107016639968 +2.9099 0.7070563149392823 0.7070549923956444 -5.118173170004514e-09 -0.0999710789534739 +2.91 0.7070563308708567 0.7070550075238788 -5.6271675071342675e-09 -0.09997108773787956 +2.9101000000000004 0.7070563467921409 0.7070550226529698 -6.144652739750733e-09 -0.0999710965196174 +2.9102 0.7070563627030467 0.7070550377830089 -6.67050689164006e-09 -0.09997110529868831 +2.9103000000000003 0.7070563786034872 0.7070550529140857 -7.204606093137722e-09 -0.09997111407509307 +2.9104 0.7070563944933768 0.7070550680462885 -7.746824608884095e-09 -0.09997112284883247 +2.9105 0.7070564103726311 0.7070550831797044 -8.29703486904948e-09 -0.09997113161990731 +2.9106000000000005 0.7070564262411677 0.7070550983144194 -8.855107499691761e-09 -0.09997114038831849 +2.9107000000000003 0.707056442098905 0.7070551134505174 -9.4209113479099e-09 -0.09997114915406671 +2.9108 0.7070564579457628 0.7070551285880813 -9.99431352607938e-09 -0.0999711579171528 +2.9109000000000003 0.7070564737816628 0.7070551437271926 -1.0575179421393188e-08 -0.09997116667757762 +2.911 0.7070564896065282 0.7070551588679312 -1.1163372748770883e-08 -0.099971175435342 +2.9111000000000002 0.7070565054202831 0.7070551740103755 -1.1758755571675272e-08 -0.09997118419044666 +2.9112000000000005 0.7070565212228537 0.7070551891546024 -1.236118833550584e-08 -0.09997119294289247 +2.9113 0.7070565370141672 0.7070552043006875 -1.2970529899257455e-08 -0.09997120169268026 +2.9114 0.7070565527941526 0.7070552194487045 -1.3586637574551641e-08 -0.09997121043981076 +2.9115 0.7070565685627405 0.7070552345987255 -1.4209367153825841e-08 -0.09997121918428481 +2.9116000000000004 0.7070565843198628 0.7070552497508216 -1.4838572944594203e-08 -0.0999712279261032 +2.9117 0.7070566000654537 0.7070552649050617 -1.5474107805443088e-08 -0.09997123666526675 +2.9118000000000004 0.7070566157994479 0.7070552800615133 -1.6115823178557143e-08 -0.09997124540177627 +2.9119 0.7070566315217826 0.7070552952202427 -1.676356912831689e-08 -0.09997125413563254 +2.912 0.7070566472323963 0.7070553103813142 -1.7417194366885907e-08 -0.09997126286683643 +2.9121000000000006 0.7070566629312289 0.7070553255447901 -1.8076546301915714e-08 -0.09997127159538866 +2.9122000000000003 0.7070566786182226 0.7070553407107318 -1.8741471062566628e-08 -0.09997128032129007 +2.9123 0.7070566942933206 0.7070553558791987 -1.941181353984009e-08 -0.0999712890445415 +2.9124 0.7070567099564684 0.7070553710502483 -2.0087417423007847e-08 -0.09997129776514375 +2.9125 0.7070567256076127 0.7070553862239366 -2.0768125233439072e-08 -0.0999713064830976 +2.9126000000000003 0.7070567412467019 0.7070554014003179 -2.1453778361463227e-08 -0.09997131519840385 +2.9127 0.7070567568736865 0.7070554165794447 -2.214421710670239e-08 -0.09997132391106334 +2.9128000000000003 0.7070567724885185 0.707055431761368 -2.283928071059732e-08 -0.09997133262107685 +2.9129 0.7070567880911516 0.7070554469461366 -2.3538807401076584e-08 -0.09997134132844515 +2.913 0.707056803681541 0.7070554621337979 -2.424263441987845e-08 -0.09997135003316901 +2.9131000000000005 0.7070568192596443 0.7070554773243978 -2.495059806982211e-08 -0.09997135873524937 +2.9132000000000002 0.7070568348254206 0.7070554925179797 -2.5662533746032695e-08 -0.09997136743468694 +2.9133 0.7070568503788304 0.7070555077145859 -2.6378275979743043e-08 -0.09997137613148252 +2.9134 0.7070568659198366 0.7070555229142566 -2.7097658472554492e-08 -0.09997138482563694 +2.9135 0.7070568814484035 0.7070555381170303 -2.7820514135468155e-08 -0.099971393517151 +2.9136 0.7070568969644971 0.7070555533229433 -2.854667513333721e-08 -0.09997140220602549 +2.9137000000000004 0.7070569124680857 0.7070555685320308 -2.927597291522456e-08 -0.09997141089226119 +2.9138 0.707056927959139 0.7070555837443259 -3.000823825668672e-08 -0.099971419575859 +2.9139 0.7070569434376287 0.7070555989598595 -3.07433013042261e-08 -0.09997142825681964 +2.914 0.7070569589035282 0.7070556141786608 -3.148099160716657e-08 -0.09997143693514388 +2.9141000000000004 0.7070569743568127 0.7070556294007577 -3.222113816275622e-08 -0.09997144561083258 +2.9142 0.7070569897974596 0.7070556446261758 -3.29635694497777e-08 -0.09997145428388654 +2.9143000000000003 0.7070570052254476 0.7070556598549389 -3.3708113475168847e-08 -0.09997146295430649 +2.9144 0.7070570206407577 0.7070556750870687 -3.4454597809801396e-08 -0.09997147162209329 +2.9145 0.7070570360433728 0.7070556903225856 -3.5202849628162766e-08 -0.09997148028724773 +2.9146000000000005 0.7070570514332775 0.7070557055615077 -3.5952695750856786e-08 -0.09997148894977062 +2.9147000000000003 0.7070570668104579 0.7070557208038512 -3.670396268233393e-08 -0.0999714976096627 +2.9148 0.7070570821749027 0.707055736049631 -3.745647665154891e-08 -0.09997150626692484 +2.9149000000000003 0.7070570975266017 0.7070557512988596 -3.821006365456979e-08 -0.09997151492155783 +2.915 0.7070571128655473 0.7070557665515478 -3.896454948948934e-08 -0.09997152357356245 +2.9151000000000002 0.7070571281917332 0.7070557818077041 -3.971975980103992e-08 -0.09997153222293946 +2.9152000000000005 0.7070571435051554 0.7070557970673365 -4.047552012163055e-08 -0.09997154086968976 +2.9153000000000002 0.7070571588058115 0.7070558123304493 -4.123165590745083e-08 -0.09997154951381411 +2.9154 0.7070571740937011 0.7070558275970459 -4.198799258192036e-08 -0.09997155815531324 +2.9155 0.7070571893688252 0.7070558428671279 -4.274435557504526e-08 -0.099971566794188 +2.9156000000000004 0.7070572046311877 0.7070558581406947 -4.350057036421468e-08 -0.0999715754304392 +2.9157 0.7070572198807934 0.7070558734177439 -4.4256462512794995e-08 -0.09997158406406759 +2.9158000000000004 0.7070572351176494 0.7070558886982714 -4.50118577122714e-08 -0.099971592695074 +2.9159 0.7070572503417645 0.7070559039822709 -4.5766581820432146e-08 -0.09997160132345917 +2.916 0.7070572655531497 0.707055919269735 -4.65204609059462e-08 -0.09997160994922402 +2.9161000000000006 0.7070572807518176 0.707055934560653 -4.7273321281821046e-08 -0.09997161857236919 +2.9162000000000003 0.7070572959377824 0.7070559498550137 -4.802498955122376e-08 -0.09997162719289555 +2.9163 0.707057311111061 0.7070559651528036 -4.877529264312418e-08 -0.09997163581080394 +2.9164 0.7070573262716713 0.7070559804540071 -4.952405785539193e-08 -0.09997164442609507 +2.9165 0.7070573414196333 0.7070559957586069 -5.027111289258087e-08 -0.09997165303876977 +2.9166000000000003 0.707057356554969 0.7070560110665842 -5.1016285906153e-08 -0.09997166164882887 +2.9167 0.7070573716777023 0.707056026377918 -5.1759405535027614e-08 -0.09997167025627315 +2.9168000000000003 0.7070573867878589 0.7070560416925853 -5.2500300939950506e-08 -0.0999716788611034 +2.9169 0.7070574018854656 0.7070560570105615 -5.323880185228308e-08 -0.09997168746332036 +2.917 0.7070574169705524 0.7070560723318206 -5.397473860392632e-08 -0.09997169606292493 +2.9171000000000005 0.7070574320431497 0.7070560876563339 -5.47079421707973e-08 -0.09997170465991782 +2.9172000000000002 0.7070574471032907 0.7070561029840712 -5.543824421142679e-08 -0.0999717132542998 +2.9173 0.70705746215101 0.707056118315001 -5.616547710403895e-08 -0.09997172184607174 +2.9174 0.707057477186344 0.7070561336490897 -5.688947398688367e-08 -0.09997173043523438 +2.9175 0.707057492209331 0.7070561489863018 -5.7610068792497346e-08 -0.09997173902178853 +2.9176 0.7070575072200107 0.7070561643265998 -5.8327096292588865e-08 -0.09997174760573495 +2.9177000000000004 0.7070575222184255 0.7070561796699453 -5.904039213078249e-08 -0.09997175618707455 +2.9178 0.7070575372046183 0.707056195016297 -5.974979286099864e-08 -0.09997176476580794 +2.9179 0.7070575521786346 0.7070562103656126 -6.045513598540095e-08 -0.09997177334193601 +2.918 0.7070575671405215 0.7070562257178481 -6.115625999277702e-08 -0.09997178191545958 +2.9181000000000004 0.7070575820903278 0.7070562410729575 -6.185300439323291e-08 -0.09997179048637944 +2.9182 0.7070575970281036 0.7070562564308933 -6.25452097561402e-08 -0.09997179905469633 +2.9183000000000003 0.7070576119539012 0.7070562717916058 -6.323271774764938e-08 -0.09997180762041104 +2.9184 0.7070576268677744 0.7070562871550443 -6.391537116451698e-08 -0.09997181618352441 +2.9185 0.7070576417697786 0.7070563025211559 -6.459301397313683e-08 -0.09997182474403717 +2.9186000000000005 0.707057656659971 0.7070563178898863 -6.526549134076506e-08 -0.09997183330195013 +2.9187000000000003 0.7070576715384104 0.7070563332611794 -6.593264967671986e-08 -0.09997184185726404 +2.9188 0.7070576864051573 0.7070563486349781 -6.659433666187167e-08 -0.09997185040997981 +2.9189000000000003 0.7070577012602737 0.7070563640112225 -6.725040128420512e-08 -0.09997185896009814 +2.919 0.7070577161038232 0.7070563793898519 -6.790069387785022e-08 -0.09997186750761979 +2.9191000000000003 0.7070577309358711 0.707056394770804 -6.85450661530064e-08 -0.09997187605254564 +2.9192000000000005 0.7070577457564844 0.7070564101540149 -6.918337123107063e-08 -0.09997188459487645 +2.9193000000000002 0.7070577605657311 0.7070564255394185 -6.981546367976557e-08 -0.09997189313461294 +2.9194 0.7070577753636812 0.707056440926948 -7.044119953959413e-08 -0.09997190167175594 +2.9195 0.7070577901504065 0.7070564563165347 -7.106043636460543e-08 -0.09997191020630627 +2.9196000000000004 0.7070578049259799 0.7070564717081085 -7.167303325015043e-08 -0.09997191873826472 +2.9197 0.7070578196904755 0.7070564871015976 -7.227885086931105e-08 -0.09997192726763204 +2.9198000000000004 0.7070578344439696 0.7070565024969289 -7.287775150022213e-08 -0.09997193579440904 +2.9199 0.7070578491865394 0.7070565178940278 -7.34695990559954e-08 -0.09997194431859648 +2.92 0.7070578639182638 0.7070565332928181 -7.405425912331703e-08 -0.09997195284019515 +2.9201000000000006 0.7070578786392226 0.7070565486932225 -7.463159898326438e-08 -0.0999719613592058 +2.9202000000000004 0.707057893349498 0.7070565640951623 -7.520148764903617e-08 -0.0999719698756293 +2.9203 0.7070579080491729 0.7070565794985568 -7.576379589327442e-08 -0.09997197838946639 +2.9204 0.7070579227383316 0.7070565949033247 -7.631839627538634e-08 -0.09997198690071785 +2.9205 0.70705793741706 0.7070566103093827 -7.686516317103459e-08 -0.09997199540938445 +2.9206000000000003 0.7070579520854452 0.7070566257166471 -7.7403972802495e-08 -0.09997200391546707 +2.9207 0.7070579667435752 0.7070566411250316 -7.793470326641211e-08 -0.09997201241896635 +2.9208000000000003 0.7070579813915401 0.7070566565344498 -7.845723455982001e-08 -0.09997202091988315 +2.9209 0.7070579960294308 0.7070566719448133 -7.897144860876532e-08 -0.09997202941821828 +2.921 0.7070580106573396 0.707056687356033 -7.947722929346063e-08 -0.09997203791397258 +2.9211000000000005 0.7070580252753594 0.7070567027680178 -7.997446247170331e-08 -0.09997204640714666 +2.9212000000000002 0.7070580398835852 0.7070567181806762 -8.04630360127026e-08 -0.09997205489774141 +2.9213 0.7070580544821128 0.7070567335939151 -8.094283981876366e-08 -0.09997206338575765 +2.9214 0.7070580690710386 0.70705674900764 -8.141376584697158e-08 -0.09997207187119604 +2.9215 0.7070580836504613 0.707056764421756 -8.187570813347755e-08 -0.09997208035405743 +2.9216 0.7070580982204797 0.7070567798361667 -8.232856282298917e-08 -0.0999720888343426 +2.9217000000000004 0.7070581127811943 0.7070567952507745 -8.277222818871971e-08 -0.09997209731205237 +2.9218 0.7070581273327066 0.7070568106654807 -8.320660464886803e-08 -0.09997210578718746 +2.9219 0.7070581418751185 0.7070568260801857 -8.363159480044569e-08 -0.09997211425974867 +2.922 0.7070581564085336 0.7070568414947891 -8.404710343662414e-08 -0.09997212272973682 +2.9221000000000004 0.7070581709330565 0.7070568569091891 -8.445303756581674e-08 -0.09997213119715266 +2.9222 0.7070581854487923 0.7070568723232828 -8.48493064298933e-08 -0.09997213966199692 +2.9223000000000003 0.7070581999558473 0.7070568877369672 -8.523582153453779e-08 -0.09997214812427047 +2.9224 0.7070582144543289 0.7070569031501378 -8.561249665445247e-08 -0.09997215658397407 +2.9225 0.7070582289443453 0.7070569185626889 -8.59792478723892e-08 -0.09997216504110848 +2.9226000000000005 0.7070582434260053 0.7070569339745143 -8.633599357741467e-08 -0.09997217349567447 +2.9227000000000003 0.7070582578994189 0.7070569493855073 -8.668265449526813e-08 -0.09997218194767288 +2.9228 0.7070582723646968 0.7070569647955596 -8.701915370310648e-08 -0.09997219039710445 +2.9229000000000003 0.7070582868219499 0.7070569802045625 -8.734541664598416e-08 -0.0999721988439699 +2.923 0.707058301271291 0.7070569956124066 -8.766137114986361e-08 -0.09997220728827005 +2.9231000000000003 0.7070583157128334 0.7070570110189816 -8.796694744503397e-08 -0.09997221573000573 +2.9232000000000005 0.70705833014669 0.7070570264241767 -8.826207817565213e-08 -0.09997222416917767 +2.9233000000000002 0.7070583445729757 0.70705704182788 -8.854669841882462e-08 -0.09997223260578664 +2.9234 0.7070583589918051 0.7070570572299795 -8.882074568981185e-08 -0.09997224103983343 +2.9235 0.7070583734032947 0.707057072630362 -8.908415997325309e-08 -0.09997224947131887 +2.9236000000000004 0.7070583878075603 0.7070570880289142 -8.933688371709492e-08 -0.09997225790024368 +2.9237 0.7070584022047186 0.7070571034255215 -8.95788618525406e-08 -0.09997226632660859 +2.9238000000000004 0.7070584165948872 0.7070571188200696 -8.981004181486674e-08 -0.09997227475041445 +2.9239 0.7070584309781847 0.7070571342124434 -9.003037353908644e-08 -0.0999722831716621 +2.924 0.707058445354729 0.7070571496025266 -9.02398094772966e-08 -0.09997229159035222 +2.9241 0.707058459724639 0.7070571649902033 -9.043830461949454e-08 -0.09997230000648556 +2.9242000000000004 0.7070584740880346 0.7070571803753569 -9.062581648490442e-08 -0.09997230842006301 +2.9243 0.7070584884450353 0.7070571957578703 -9.0802305145396e-08 -0.09997231683108529 +2.9244 0.7070585027957612 0.7070572111376255 -9.096773322461726e-08 -0.0999723252395531 +2.9245 0.7070585171403332 0.707057226514505 -9.112206591187222e-08 -0.09997233364546726 +2.9246000000000003 0.7070585314788722 0.7070572418883907 -9.126527096472298e-08 -0.09997234204882861 +2.9247 0.7070585458114996 0.7070572572591638 -9.139731872026546e-08 -0.09997235044963788 +2.9248000000000003 0.7070585601383368 0.7070572726267055 -9.151818209512941e-08 -0.09997235884789583 +2.9249 0.7070585744595057 0.7070572879908968 -9.162783660282559e-08 -0.09997236724360326 +2.925 0.7070585887751284 0.7070573033516185 -9.172626033986803e-08 -0.09997237563676094 +2.9251000000000005 0.707058603085327 0.7070573187087508 -9.18134340065907e-08 -0.0999723840273696 +2.9252000000000002 0.707058617390224 0.707057334062174 -9.188934090888223e-08 -0.09997239241543007 +2.9253 0.7070586316899421 0.7070573494117687 -9.19539669495123e-08 -0.09997240080094313 +2.9254000000000002 0.707058645984604 0.7070573647574148 -9.20073006420094e-08 -0.09997240918390955 +2.9255 0.7070586602743323 0.7070573800989919 -9.20493331080588e-08 -0.09997241756433008 +2.9256 0.7070586745592499 0.7070573954363801 -9.208005808183928e-08 -0.09997242594220546 +2.9257000000000004 0.7070586888394799 0.7070574107694596 -9.209947190742113e-08 -0.09997243431753657 +2.9258 0.7070587031151447 0.7070574260981095 -9.210757353703136e-08 -0.09997244269032407 +2.9259 0.7070587173863676 0.7070574414222102 -9.210436453539056e-08 -0.09997245106056878 +2.926 0.7070587316532712 0.7070574567416414 -9.208984908058021e-08 -0.09997245942827143 +2.9261000000000004 0.7070587459159785 0.7070574720562832 -9.206403394929757e-08 -0.09997246779343284 +2.9262 0.7070587601746119 0.7070574873660156 -9.202692852899874e-08 -0.0999724761560538 +2.9263000000000003 0.7070587744292938 0.7070575026707189 -9.197854480835765e-08 -0.09997248451613502 +2.9264 0.7070587886801469 0.7070575179702735 -9.191889737553138e-08 -0.09997249287367733 +2.9265 0.707058802927293 0.7070575332645601 -9.184800341122124e-08 -0.09997250122868147 +2.9266000000000005 0.7070588171708541 0.707057548553459 -9.176588268954011e-08 -0.09997250958114817 +2.9267000000000003 0.7070588314109519 0.7070575638368517 -9.167255756326737e-08 -0.09997251793107824 +2.9268 0.7070588456477083 0.7070575791146193 -9.156805296645087e-08 -0.0999725262784725 +2.9269000000000003 0.7070588598812437 0.7070575943866437 -9.14523964066008e-08 -0.0999725346233317 +2.927 0.7070588741116793 0.7070576096528067 -9.132561795428124e-08 -0.09997254296565655 +2.9271000000000003 0.7070588883391355 0.7070576249129904 -9.118775023703868e-08 -0.09997255130544788 +2.9272000000000005 0.7070589025637324 0.7070576401670775 -9.103882843072841e-08 -0.09997255964270642 +2.9273000000000002 0.7070589167855891 0.7070576554149512 -9.08788902551777e-08 -0.09997256797743292 +2.9274 0.7070589310048251 0.707057670656495 -9.07079759533691e-08 -0.09997257630962816 +2.9275 0.7070589452215597 0.7070576858915928 -9.052612829404255e-08 -0.09997258463929298 +2.9276000000000004 0.7070589594359105 0.7070577011201291 -9.03333925552155e-08 -0.09997259296642808 +2.9277 0.7070589736479953 0.707057716341989 -9.012981651117247e-08 -0.09997260129103425 +2.9278000000000004 0.7070589878579316 0.7070577315570578 -8.991545042552618e-08 -0.09997260961311222 +2.9279 0.7070590020658356 0.7070577467652219 -8.969034703213558e-08 -0.09997261793266282 +2.928 0.7070590162718235 0.7070577619663676 -8.945456153250375e-08 -0.09997262624968674 +2.9281 0.7070590304760109 0.7070577771603825 -8.920815156802236e-08 -0.0999726345641848 +2.9282000000000004 0.7070590446785122 0.7070577923471546 -8.895117721997164e-08 -0.09997264287615776 +2.9283 0.7070590588794416 0.7070578075265725 -8.868370098696898e-08 -0.09997265118560641 +2.9284 0.7070590730789128 0.7070578226985258 -8.840578777022379e-08 -0.09997265949253152 +2.9285 0.7070590872770379 0.707057837862904 -8.811750486312914e-08 -0.09997266779693378 +2.9286000000000003 0.7070591014739291 0.7070578530195983 -8.78189219304451e-08 -0.09997267609881408 +2.9287 0.7070591156696975 0.7070578681685006 -8.751011099095152e-08 -0.0999726843981731 +2.9288000000000003 0.7070591298644532 0.7070578833095026 -8.719114640096809e-08 -0.09997269269501158 +2.9289 0.7070591440583058 0.7070578984424978 -8.686210483787454e-08 -0.09997270098933034 +2.929 0.7070591582513641 0.7070579135673805 -8.652306528102865e-08 -0.09997270928113017 +2.9291000000000005 0.7070591724437357 0.7070579286840453 -8.61741089926843e-08 -0.09997271757041173 +2.9292000000000002 0.7070591866355271 0.7070579437923884 -8.581531949804211e-08 -0.09997272585717587 +2.9293 0.7070592008268446 0.7070579588923063 -8.54467825653002e-08 -0.09997273414142328 +2.9294000000000002 0.7070592150177932 0.7070579739836973 -8.506858618830687e-08 -0.09997274242315488 +2.9295 0.7070592292084767 0.7070579890664592 -8.468082055793774e-08 -0.09997275070237123 +2.9296 0.7070592433989982 0.7070580041404922 -8.428357805342207e-08 -0.0999727589790732 +2.9297000000000004 0.7070592575894594 0.7070580192056972 -8.387695320504623e-08 -0.09997276725326154 +2.9298 0.7070592717799618 0.7070580342619757 -8.346104267854121e-08 -0.09997277552493705 +2.9299 0.7070592859706051 0.7070580493092307 -8.303594525773533e-08 -0.09997278379410048 +2.93 0.7070593001614878 0.7070580643473658 -8.260176181853346e-08 -0.09997279206075255 +2.9301000000000004 0.7070593143527077 0.7070580793762864 -8.21585952959572e-08 -0.09997280032489406 +2.9302 0.7070593285443616 0.7070580943958986 -8.17065506693998e-08 -0.0999728085865258 +2.9303000000000003 0.7070593427365446 0.7070581094061095 -8.124573493920734e-08 -0.09997281684564845 +2.9304 0.7070593569293508 0.7070581244068276 -8.077625708764746e-08 -0.09997282510226281 +2.9305 0.7070593711228738 0.7070581393979628 -8.02982280676337e-08 -0.09997283335636968 +2.9306000000000005 0.7070593853172049 0.7070581543794259 -7.981176077323515e-08 -0.0999728416079698 +2.9307000000000003 0.7070593995124346 0.7070581693511286 -7.931697000845145e-08 -0.0999728498570639 +2.9308 0.7070594137086521 0.7070581843129848 -7.881397246119193e-08 -0.09997285810365267 +2.9309000000000003 0.7070594279059462 0.707058199264909 -7.830288668419366e-08 -0.09997286634773705 +2.931 0.7070594421044031 0.7070582142068171 -7.778383305425546e-08 -0.0999728745893177 +2.9311000000000003 0.7070594563041082 0.7070582291386263 -7.725693375142118e-08 -0.09997288282839537 +2.9312000000000005 0.7070594705051455 0.7070582440602554 -7.672231273035679e-08 -0.09997289106497083 +2.9313000000000002 0.7070594847075979 0.7070582589716244 -7.618009568999273e-08 -0.09997289929904486 +2.9314 0.7070594989115471 0.7070582738726546 -7.563041003882942e-08 -0.09997290753061826 +2.9315 0.7070595131170723 0.7070582887632686 -7.507338487932474e-08 -0.09997291575969168 +2.9316000000000004 0.7070595273242526 0.7070583036433904 -7.450915095888813e-08 -0.09997292398626595 +2.9317 0.7070595415331651 0.7070583185129459 -7.393784065253331e-08 -0.09997293221034184 +2.9318 0.7070595557438852 0.7070583333718616 -7.335958792818384e-08 -0.09997294043192007 +2.9319 0.7070595699564874 0.7070583482200665 -7.277452831588177e-08 -0.0999729486510014 +2.932 0.7070595841710445 0.7070583630574903 -7.218279887222581e-08 -0.09997295686758664 +2.9321 0.7070595983876276 0.7070583778840642 -7.158453815348312e-08 -0.09997296508167647 +2.9322000000000004 0.7070596126063062 0.7070583926997214 -7.097988617742537e-08 -0.09997297329327165 +2.9323 0.7070596268271492 0.707058407504396 -7.03689843981753e-08 -0.09997298150237302 +2.9324 0.7070596410502228 0.7070584222980243 -6.975197566674168e-08 -0.09997298970898127 +2.9325 0.7070596552755923 0.7070584370805437 -6.912900420152912e-08 -0.0999729979130972 +2.9326000000000003 0.7070596695033211 0.7070584518518935 -6.850021555017405e-08 -0.09997300611472153 +2.9327 0.7070596837334717 0.7070584666120141 -6.786575656265656e-08 -0.09997301431385502 +2.9328000000000003 0.7070596979661041 0.7070584813608478 -6.722577534706495e-08 -0.09997302251049846 +2.9329 0.7070597122012776 0.7070584960983388 -6.65804212427075e-08 -0.09997303070465263 +2.933 0.7070597264390488 0.707058510824432 -6.592984478671904e-08 -0.09997303889631821 +2.9331000000000005 0.7070597406794734 0.7070585255390752 -6.527419767112658e-08 -0.09997304708549602 +2.9332000000000003 0.7070597549226054 0.7070585402422167 -6.461363271639473e-08 -0.09997305527218678 +2.9333 0.7070597691684968 0.7070585549338069 -6.394830382719027e-08 -0.09997306345639118 +2.9334000000000002 0.7070597834171984 0.7070585696137979 -6.327836596072348e-08 -0.09997307163811003 +2.9335 0.7070597976687591 0.7070585842821437 -6.260397509292095e-08 -0.09997307981734416 +2.9336 0.7070598119232263 0.7070585989387997 -6.192528817852705e-08 -0.09997308799409423 +2.9337000000000004 0.7070598261806451 0.7070586135837231 -6.124246311597567e-08 -0.09997309616836102 +2.9338 0.7070598404410595 0.7070586282168723 -6.055565871182847e-08 -0.09997310434014528 +2.9339 0.7070598547045116 0.7070586428382084 -5.986503464347828e-08 -0.09997311250944776 +2.934 0.707059868971042 0.7070586574476934 -5.917075141621472e-08 -0.09997312067626923 +2.9341000000000004 0.7070598832406889 0.7070586720452913 -5.847297033546861e-08 -0.09997312884061042 +2.9342 0.7070598975134895 0.7070586866309679 -5.7771853461275474e-08 -0.09997313700247211 +2.9343000000000004 0.7070599117894791 0.7070587012046912 -5.7067563577917896e-08 -0.09997314516185507 +2.9344 0.7070599260686907 0.7070587157664299 -5.636026414947322e-08 -0.09997315331876003 +2.9345 0.7070599403511559 0.7070587303161553 -5.565011928663696e-08 -0.09997316147318772 +2.9346000000000005 0.7070599546369051 0.7070587448538403 -5.493729370617366e-08 -0.09997316962513897 +2.9347000000000003 0.7070599689259658 0.7070587593794593 -5.4221952694270825e-08 -0.09997317777461445 +2.9348 0.7070599832183644 0.7070587738929887 -5.350426206533927e-08 -0.09997318592161492 +2.9349000000000003 0.7070599975141254 0.7070587883944064 -5.278438812666812e-08 -0.09997319406614112 +2.935 0.7070600118132718 0.7070588028836929 -5.206249763852616e-08 -0.09997320220819386 +2.9351000000000003 0.7070600261158242 0.7070588173608295 -5.133875777686529e-08 -0.09997321034777384 +2.9352000000000005 0.7070600404218019 0.7070588318258 -5.061333609320505e-08 -0.09997321848488186 +2.9353000000000002 0.707060054731222 0.7070588462785895 -4.9886400474083437e-08 -0.0999732266195186 +2.9354 0.7070600690441005 0.7070588607191853 -4.91581191076635e-08 -0.09997323475168489 +2.9355 0.7070600833604501 0.7070588751475766 -4.84286604411242e-08 -0.09997324288138142 +2.9356000000000004 0.7070600976802834 0.7070588895637537 -4.7698193139677526e-08 -0.09997325100860892 +2.9357 0.7070601120036104 0.7070589039677095 -4.696688605111514e-08 -0.09997325913336819 +2.9358 0.7070601263304392 0.7070589183594385 -4.623490816759021e-08 -0.09997326725566001 +2.9359 0.7070601406607766 0.7070589327389367 -4.5502428583387745e-08 -0.09997327537548512 +2.936 0.7070601549946268 0.7070589471062021 -4.4769616456435436e-08 -0.09997328349284418 +2.9361 0.7070601693319928 0.7070589614612348 -4.403664097054629e-08 -0.09997329160773803 +2.9362000000000004 0.7070601836728755 0.7070589758040362 -4.3303671296766834e-08 -0.09997329972016737 +2.9363 0.7070601980172739 0.7070589901346098 -4.257087655292621e-08 -0.09997330783013297 +2.9364 0.7070602123651855 0.707059004452961 -4.1838425765631506e-08 -0.09997331593763553 +2.9365 0.7070602267166057 0.7070590187590973 -4.110648782899352e-08 -0.09997332404267587 +2.9366000000000003 0.7070602410715287 0.7070590330530271 -4.0375231469627366e-08 -0.09997333214525472 +2.9367 0.7070602554299457 0.7070590473347612 -3.9644825204426196e-08 -0.09997334024537277 +2.9368000000000003 0.707060269791847 0.7070590616043122 -3.891543730430479e-08 -0.09997334834303082 +2.9369 0.7070602841572212 0.7070590758616948 -3.8187235751698835e-08 -0.09997335643822965 +2.937 0.7070602985260546 0.7070590901069246 -3.74603882066565e-08 -0.09997336453096989 +2.9371000000000005 0.7070603128983317 0.7070591043400198 -3.673506196542192e-08 -0.09997337262125237 +2.9372000000000003 0.7070603272740357 0.707059118561 -3.6011423922162854e-08 -0.09997338070907782 +2.9373 0.7070603416531477 0.7070591327698874 -3.528964053140307e-08 -0.09997338879444707 +2.9374000000000002 0.707060356035647 0.7070591469667045 -3.456987776725637e-08 -0.09997339687736079 +2.9375 0.707060370421511 0.7070591611514765 -3.385230108970787e-08 -0.09997340495781966 +2.9376 0.7070603848107158 0.7070591753242305 -3.3137075402438557e-08 -0.09997341303582453 +2.9377000000000004 0.7070603992032354 0.7070591894849951 -3.242436501823924e-08 -0.09997342111137614 +2.9378 0.7070604135990414 0.7070592036338006 -3.171433361867822e-08 -0.09997342918447516 +2.9379 0.7070604279981048 0.7070592177706789 -3.100714421658789e-08 -0.09997343725512235 +2.938 0.7070604424003943 0.7070592318956643 -3.030295912050292e-08 -0.09997344532331849 +2.9381000000000004 0.7070604568058771 0.7070592460087923 -2.9601939898014212e-08 -0.09997345338906435 +2.9382 0.7070604712145184 0.7070592601101 -2.8904247334352387e-08 -0.0999734614523606 +2.9383000000000004 0.7070604856262817 0.7070592741996267 -2.8210041401596428e-08 -0.09997346951320801 +2.9384 0.707060500041129 0.7070592882774125 -2.7519481214655084e-08 -0.09997347757160735 +2.9385 0.7070605144590205 0.7070593023435008 -2.683272500286077e-08 -0.0999734856275594 +2.9386000000000005 0.7070605288799144 0.7070593163979352 -2.6149930066818317e-08 -0.09997349368106478 +2.9387000000000003 0.7070605433037678 0.7070593304407613 -2.547125274891468e-08 -0.09997350173212427 +2.9388 0.707060557730536 0.7070593444720271 -2.4796848390601367e-08 -0.09997350978073873 +2.9389000000000003 0.7070605721601723 0.7070593584917818 -2.412687130247046e-08 -0.09997351782690884 +2.939 0.7070605865926283 0.7070593725000756 -2.3461474725657017e-08 -0.09997352587063527 +2.9391000000000003 0.7070606010278546 0.707059386496961 -2.2800810796710924e-08 -0.09997353391191881 +2.9392000000000005 0.7070606154657998 0.7070594004824925 -2.214503051593819e-08 -0.09997354195076025 +2.9393000000000002 0.7070606299064104 0.7070594144567255 -2.1494283711839118e-08 -0.09997354998716024 +2.9394 0.7070606443496322 0.7070594284197169 -2.0848719004245425e-08 -0.09997355802111958 +2.9395 0.7070606587954089 0.707059442371526 -2.0208483772227864e-08 -0.09997356605263896 +2.9396000000000004 0.7070606732436826 0.7070594563122129 -1.9573724120269115e-08 -0.0999735740817192 +2.9397 0.7070606876943945 0.7070594702418396 -1.894458484703876e-08 -0.09997358210836099 +2.9398 0.7070607021474831 0.7070594841604696 -1.832120940983145e-08 -0.09997359013256506 +2.9399 0.7070607166028864 0.7070594980681677 -1.7703739889005088e-08 -0.09997359815433216 +2.94 0.7070607310605403 0.7070595119650007 -1.7092316964562038e-08 -0.09997360617366306 +2.9401 0.7070607455203796 0.7070595258510368 -1.6487079876250504e-08 -0.09997361419055846 +2.9402000000000004 0.7070607599823373 0.7070595397263448 -1.5888166392339503e-08 -0.09997362220501911 +2.9403 0.7070607744463453 0.707059553590996 -1.5295712783164328e-08 -0.09997363021704579 +2.9404 0.7070607889123339 0.7070595674450627 -1.4709853786432081e-08 -0.0999736382266392 +2.9405 0.7070608033802319 0.7070595812886189 -1.4130722575996651e-08 -0.09997364623380013 +2.9406000000000003 0.7070608178499661 0.7070595951217398 -1.3558450735404182e-08 -0.09997365423852923 +2.9407 0.7070608323214631 0.7070596089445018 -1.2993168221463874e-08 -0.09997366224082732 +2.9408000000000003 0.7070608467946473 0.707059622756983 -1.2435003342130269e-08 -0.09997367024069509 +2.9409 0.707060861269442 0.7070596365592627 -1.1884082725278217e-08 -0.09997367823813329 +2.941 0.7070608757457689 0.7070596503514217 -1.1340531285309458e-08 -0.0999736862331426 +2.9411000000000005 0.7070608902235491 0.7070596641335416 -1.0804472201468573e-08 -0.09997369422572386 +2.9412000000000003 0.7070609047027019 0.7070596779057062 -1.0276026884015882e-08 -0.09997370221587777 +2.9413 0.7070609191831447 0.7070596916679999 -9.755314955145478e-09 -0.09997371020360503 +2.9414000000000002 0.7070609336647946 0.7070597054205082 -9.242454209953954e-09 -0.09997371818890638 +2.9415 0.7070609481475673 0.7070597191633188 -8.737560597792127e-09 -0.09997372617178261 +2.9416 0.7070609626313767 0.7070597328965198 -8.24074819667786e-09 -0.09997373415223444 +2.9417000000000004 0.7070609771161362 0.7070597466202004 -7.752129181637368e-09 -0.09997374213026253 +2.9418 0.7070609916017577 0.7070597603344515 -7.271813811694783e-09 -0.09997375010586769 +2.9419 0.7070610060881521 0.7070597740393652 -6.799910385636709e-09 -0.09997375807905073 +2.942 0.7070610205752289 0.7070597877350341 -6.336525236808055e-09 -0.09997376604981227 +2.9421000000000004 0.7070610350628965 0.7070598014215526 -5.881762696682835e-09 -0.09997377401815308 +2.9422 0.7070610495510623 0.7070598150990155 -5.435725074047493e-09 -0.09997378198407386 +2.9423000000000004 0.7070610640396326 0.7070598287675196 -4.998512637653663e-09 -0.09997378994757544 +2.9424 0.7070610785285127 0.7070598424271619 -4.570223587595235e-09 -0.09997379790865844 +2.9425 0.7070610930176068 0.7070598560780407 -4.150954034491672e-09 -0.09997380586732363 +2.9426000000000005 0.7070611075068183 0.7070598697202555 -3.74079797953869e-09 -0.09997381382357177 +2.9427000000000003 0.7070611219960494 0.7070598833539068 -3.3398472945589397e-09 -0.09997382177740363 +2.9428 0.7070611364852013 0.7070598969790955 -2.9481916951137888e-09 -0.09997382972881988 +2.9429000000000003 0.7070611509741742 0.7070599105959241 -2.5659187309623466e-09 -0.09997383767782121 +2.943 0.707061165462868 0.7070599242044957 -2.193113751366993e-09 -0.09997384562440846 +2.9431000000000003 0.7070611799511809 0.7070599378049145 -1.8298599033586549e-09 -0.09997385356858234 +2.9432000000000005 0.7070611944390105 0.707059951397285 -1.4762381057159546e-09 -0.09997386151034349 +2.9433000000000002 0.707061208926254 0.7070599649817131 -1.132327023811719e-09 -0.0999738694496927 +2.9434 0.7070612234128072 0.7070599785583057 -7.982030600720003e-10 -0.09997387738663077 +2.9435 0.7070612378985655 0.70705999212717 -4.739403418330124e-10 -0.09997388532115838 +2.9436000000000004 0.7070612523834232 0.707060005688414 -1.5961069098346936e-10 -0.09997389325327627 +2.9437 0.707061266867274 0.7070600192421466 1.4471638470903159e-10 -0.09997390118298513 +2.9438 0.707061281350011 0.7070600327884773 4.3897370027162763e-10 -0.09997390911028571 +2.9439 0.7070612958315265 0.7070600463275167 7.230964160775954e-10 -0.0999739170351788 +2.944 0.7070613103117123 0.7070600598593753 9.97022055193586e-10 -0.09997392495766506 +2.9441 0.707061324790459 0.707060073384165 1.2606905094511567e-09 -0.09997393287774525 +2.9442000000000004 0.7070613392676574 0.7070600869019977 1.5140440533245592e-09 -0.09997394079542006 +2.9443 0.707061353743197 0.7070601004129866 1.7570273638800593e-09 -0.09997394871069032 +2.9444 0.7070613682169672 0.7070601139172444 1.9895875199085755e-09 -0.0999739566235566 +2.9445 0.7070613826888565 0.7070601274148857 2.2116740314159777e-09 -0.09997396453401976 +2.9446000000000003 0.7070613971587534 0.7070601409060246 2.4232388326841936e-09 -0.09997397244208052 +2.9447 0.7070614116265455 0.707060154390776 2.62423630308789e-09 -0.09997398034773958 +2.9448000000000003 0.7070614260921195 0.7070601678692552 2.8146232714312824e-09 -0.09997398825099763 +2.9449 0.7070614405553627 0.7070601813415778 2.9943590332953685e-09 -0.09997399615185538 +2.945 0.7070614550161618 0.7070601948078605 3.1634053458337585e-09 -0.09997400405031376 +2.9451000000000005 0.7070614694744024 0.7070602082682197 3.3217264537935276e-09 -0.09997401194637334 +2.9452000000000003 0.7070614839299703 0.7070602217227722 3.4692890817089594e-09 -0.09997401984003487 +2.9453 0.7070614983827503 0.707060235171635 3.606062446044611e-09 -0.09997402773129901 +2.9454000000000002 0.7070615128326281 0.707060248614926 3.732018265603654e-09 -0.0999740356201666 +2.9455 0.7070615272794885 0.7070602620527627 3.847130761527873e-09 -0.09997404350663831 +2.9456 0.7070615417232153 0.7070602754852635 3.9513766659712846e-09 -0.09997405139071487 +2.9457000000000004 0.7070615561636935 0.7070602889125461 4.044735223834861e-09 -0.09997405927239698 +2.9458 0.707061570600807 0.7070603023347302 4.1271881971033375e-09 -0.0999740671516855 +2.9459 0.7070615850344395 0.7070603157519332 4.19871987351883e-09 -0.09997407502858101 +2.946 0.7070615994644748 0.7070603291642743 4.25931706311139e-09 -0.09997408290308424 +2.9461000000000004 0.7070616138907968 0.7070603425718723 4.308969103403171e-09 -0.09997409077519598 +2.9462 0.7070616283132893 0.7070603559748465 4.3476678602757945e-09 -0.09997409864491698 +2.9463000000000004 0.7070616427318355 0.7070603693733155 4.3754077314397954e-09 -0.09997410651224789 +2.9464 0.7070616571463189 0.7070603827673987 4.3921856377610036e-09 -0.09997411437718945 +2.9465 0.7070616715566231 0.7070603961572148 4.39800104060778e-09 -0.09997412223974242 +2.9466000000000006 0.7070616859626319 0.7070604095428832 4.392855925371142e-09 -0.09997413009990753 +2.9467000000000003 0.7070617003642288 0.7070604229245226 4.376754801464766e-09 -0.09997413795768552 +2.9468 0.7070617147612971 0.707060436302252 4.34970470926388e-09 -0.09997414581307706 +2.9469000000000003 0.7070617291537211 0.7070604496761903 4.311715220105261e-09 -0.09997415366608295 +2.947 0.7070617435413844 0.7070604630464559 4.262798414603197e-09 -0.09997416151670384 +2.9471000000000003 0.7070617579241711 0.7070604764131672 4.202968899129356e-09 -0.09997416936494044 +2.9472000000000005 0.7070617723019654 0.7070604897764425 4.132243791067636e-09 -0.09997417721079349 +2.9473000000000003 0.7070617866746519 0.7070605031364003 4.050642713609998e-09 -0.09997418505426375 +2.9474 0.7070618010421152 0.7070605164931583 3.958187797491186e-09 -0.09997419289535195 +2.9475 0.7070618154042405 0.7070605298468338 3.854903671447751e-09 -0.09997420073405874 +2.9476000000000004 0.7070618297609128 0.7070605431975441 3.740817451809708e-09 -0.09997420857038489 +2.9477 0.707061844112018 0.7070605565454064 3.6159587407658123e-09 -0.09997421640433114 +2.9478 0.7070618584574418 0.7070605698905371 3.4803596194246667e-09 -0.09997422423589819 +2.9479 0.7070618727970706 0.7070605832330525 3.3340546313348485e-09 -0.09997423206508675 +2.948 0.7070618871307912 0.7070605965730683 3.1770807850869942e-09 -0.09997423989189752 +2.9481 0.7070619014584908 0.7070606099107002 3.0094775360992032e-09 -0.09997424771633134 +2.9482000000000004 0.7070619157800571 0.707060623246063 2.8312867874843994e-09 -0.09997425553838887 +2.9483 0.7070619300953779 0.7070606365792713 2.642552864896841e-09 -0.0999742633580708 +2.9484 0.7070619444043419 0.7070606499104388 2.4433225156647587e-09 -0.09997427117537787 +2.9485 0.7070619587068383 0.7070606632396791 2.2336448949125676e-09 -0.0999742789903108 +2.9486000000000003 0.7070619730027567 0.707060676567105 2.0135715534178034e-09 -0.09997428680287035 +2.9487 0.7070619872919874 0.7070606898928287 1.7831564254680576e-09 -0.09997429461305715 +2.9488000000000003 0.7070620015744213 0.7070607032169616 1.5424558115137432e-09 -0.09997430242087192 +2.9489 0.70706201584995 0.7070607165396152 1.2915283738312855e-09 -0.0999743102263155 +2.949 0.7070620301184656 0.7070607298608997 1.0304351157064406e-09 -0.0999743180293885 +2.9491000000000005 0.7070620443798605 0.7070607431809248 7.592393614849757e-10 -0.09997432583009168 +2.9492000000000003 0.7070620586340288 0.7070607564997996 4.780067548379452e-10 -0.09997433362842573 +2.9493 0.7070620728808648 0.7070607698176323 1.8680523360820045e-10 -0.09997434142439143 +2.9494000000000002 0.7070620871202634 0.7070607831345304 -1.1429499274101529e-10 -0.09997434921798948 +2.9495 0.7070621013521206 0.7070607964506004 -4.252214405239818e-10 -0.09997435700922057 +2.9496 0.7070621155763326 0.7070608097659483 -7.458993882616949e-10 -0.09997436479808541 +2.9497000000000004 0.7070621297927974 0.7070608230806794 -1.0762518862228454e-09 -0.0999743725845848 +2.9498 0.7070621440014132 0.7070608363948978 -1.4161997729036924e-09 -0.0999743803687194 +2.9499 0.707062158202079 0.707060849708707 -1.7656616975794681e-09 -0.09997438815048994 +2.95 0.7070621723946948 0.7070608630222088 -2.1245541437231452e-09 -0.0999743959298971 +2.9501000000000004 0.7070621865791624 0.7070608763355054 -2.492791436811692e-09 -0.09997440370694168 +2.9502 0.7070622007553828 0.7070608896486972 -2.8702857798879045e-09 -0.09997441148162431 +2.9503000000000004 0.7070622149232594 0.7070609029618833 -3.256947257029852e-09 -0.09997441925394572 +2.9504 0.7070622290826961 0.7070609162751627 -3.652683873249518e-09 -0.09997442702390663 +2.9505 0.7070622432335979 0.7070609295886332 -4.05740156403378e-09 -0.09997443479150782 +2.9506000000000006 0.7070622573758707 0.7070609429023911 -4.471004220497898e-09 -0.09997444255674995 +2.9507000000000003 0.7070622715094216 0.7070609562165318 -4.8933937136716454e-09 -0.09997445031963376 +2.9508 0.7070622856341584 0.7070609695311498 -5.3244699205201584e-09 -0.09997445808015988 +2.9509000000000003 0.7070622997499907 0.7070609828463388 -5.764130736954365e-09 -0.09997446583832915 +2.951 0.7070623138568286 0.7070609961621903 -6.212272115994899e-09 -0.09997447359414223 +2.9511000000000003 0.7070623279545839 0.7070610094787957 -6.66878808164989e-09 -0.09997448134759984 +2.9512000000000005 0.7070623420431689 0.7070610227962448 -7.133570757537899e-09 -0.09997448909870263 +2.9513000000000003 0.7070623561224978 0.7070610361146266 -7.606510393776134e-09 -0.09997449684745147 +2.9514 0.7070623701924854 0.7070610494340284 -8.087495394736022e-09 -0.09997450459384699 +2.9515 0.707062384253048 0.7070610627545365 -8.576412336390449e-09 -0.0999745123378899 +2.9516000000000004 0.7070623983041029 0.7070610760762357 -9.073146000140864e-09 -0.09997452007958088 +2.9517 0.7070624123455691 0.7070610893992102 -9.577579401440217e-09 -0.09997452781892072 +2.9518 0.7070624263773664 0.7070611027235423 -1.0089593815813813e-08 -0.09997453555591006 +2.9519 0.7070624403994161 0.707061116049313 -1.0609068803145438e-08 -0.09997454329054961 +2.952 0.7070624544116411 0.7070611293766025 -1.113588223673398e-08 -0.09997455102284014 +2.9521 0.7070624684139651 0.7070611427054891 -1.166991033625317e-08 -0.09997455875278236 +2.9522000000000004 0.7070624824063136 0.70706115603605 -1.221102769290508e-08 -0.09997456648037692 +2.9523 0.7070624963886132 0.7070611693683615 -1.2759107303680906e-08 -0.09997457420562461 +2.9524 0.7070625103607919 0.7070611827024975 -1.3314020593478693e-08 -0.09997458192852607 +2.9525 0.7070625243227795 0.7070611960385312 -1.3875637452399892e-08 -0.09997458964908208 +2.9526000000000003 0.7070625382745066 0.7070612093765344 -1.4443826260035486e-08 -0.09997459736729332 +2.9527 0.7070625522159055 0.7070612227165772 -1.501845392362991e-08 -0.09997460508316051 +2.9528000000000003 0.7070625661469099 0.7070612360587283 -1.5599385901499813e-08 -0.09997461279668433 +2.9529 0.7070625800674555 0.7070612494030553 -1.6186486241197978e-08 -0.0999746205078656 +2.953 0.7070625939774785 0.7070612627496238 -1.677961760770258e-08 -0.09997462821670493 +2.9531000000000005 0.7070626078769173 0.707061276098498 -1.737864131377484e-08 -0.09997463592320305 +2.9532000000000003 0.7070626217657114 0.7070612894497408 -1.7983417357255588e-08 -0.09997464362736064 +2.9533 0.7070626356438023 0.7070613028034136 -1.8593804448820833e-08 -0.09997465132917849 +2.9534000000000002 0.7070626495111327 0.7070613161595761 -1.920966004841096e-08 -0.09997465902865726 +2.9535 0.7070626633676467 0.7070613295182864 -1.9830840397756788e-08 -0.09997466672579763 +2.9536000000000002 0.70706267721329 0.7070613428796011 -2.0457200556808774e-08 -0.09997467442060032 +2.9537000000000004 0.7070626910480106 0.7070613562435755 -2.108859442715577e-08 -0.0999746821130661 +2.9538 0.7070627048717572 0.707061369610263 -2.1724874799729926e-08 -0.09997468980319565 +2.9539 0.7070627186844802 0.7070613829797153 -2.2365893379960172e-08 -0.09997469749098963 +2.954 0.707062732486132 0.707061396351983 -2.3011500826369824e-08 -0.0999747051764488 +2.9541000000000004 0.7070627462766668 0.707061409727115 -2.36615467818016e-08 -0.09997471285957389 +2.9542 0.7070627600560395 0.707061423105158 -2.4315879911581545e-08 -0.0999747205403656 +2.9543000000000004 0.7070627738242075 0.7070614364861572 -2.4974347938647168e-08 -0.09997472821882458 +2.9544 0.7070627875811291 0.7070614498701566 -2.5636797678675605e-08 -0.09997473589495154 +2.9545 0.7070628013267655 0.7070614632571987 -2.6303075071742316e-08 -0.09997474356874732 +2.9546000000000006 0.7070628150610783 0.7070614766473236 -2.697302522438813e-08 -0.09997475124021254 +2.9547000000000003 0.707062828784031 0.7070614900405698 -2.7646492442362156e-08 -0.09997475890934787 +2.9548 0.707062842495589 0.7070615034369747 -2.8323320267484645e-08 -0.09997476657615399 +2.9549000000000003 0.70706285619572 0.7070615168365736 -2.900335151190779e-08 -0.09997477424063168 +2.955 0.7070628698843923 0.7070615302394003 -2.9686428297363843e-08 -0.09997478190278167 +2.9551000000000003 0.7070628835615766 0.7070615436454866 -3.03723920905101e-08 -0.09997478956260461 +2.9552000000000005 0.707062897227245 0.7070615570548628 -3.1061083741743337e-08 -0.09997479722010122 +2.9553000000000003 0.7070629108813717 0.7070615704675578 -3.1752343518810094e-08 -0.09997480487527223 +2.9554 0.7070629245239319 0.7070615838835981 -3.2446011145187414e-08 -0.0999748125281183 +2.9555 0.7070629381549032 0.707061597303009 -3.3141925838029926e-08 -0.09997482017864012 +2.9556000000000004 0.7070629517742648 0.7070616107258137 -3.383992634503272e-08 -0.09997482782683847 +2.9557 0.7070629653819975 0.7070616241520342 -3.453985097999317e-08 -0.09997483547271407 +2.9558 0.707062978978084 0.70706163758169 -3.5241537663360106e-08 -0.09997484311626754 +2.9559 0.7070629925625083 0.7070616510147992 -3.594482395844617e-08 -0.0999748507574996 +2.956 0.7070630061352565 0.7070616644513785 -3.664954710839909e-08 -0.09997485839641093 +2.9561 0.7070630196963172 0.7070616778914427 -3.73555440726309e-08 -0.0999748660330024 +2.9562000000000004 0.7070630332456793 0.7070616913350047 -3.806265156931863e-08 -0.09997487366727462 +2.9563 0.7070630467833343 0.7070617047820752 -3.877070610706305e-08 -0.09997488129922823 +2.9564 0.7070630603092752 0.7070617182326636 -3.947954402690147e-08 -0.09997488892886394 +2.9565 0.7070630738234971 0.7070617316867781 -4.0189001538357486e-08 -0.09997489655618257 +2.9566000000000003 0.7070630873259964 0.7070617451444241 -4.0898914757821724e-08 -0.09997490418118471 +2.9567 0.7070631008167716 0.7070617586056056 -4.16091197469326e-08 -0.09997491180387108 +2.9568000000000003 0.7070631142958228 0.7070617720703252 -4.2319452548924196e-08 -0.09997491942424239 +2.9569 0.7070631277631518 0.7070617855385838 -4.302974922815899e-08 -0.09997492704229943 +2.957 0.7070631412187627 0.7070617990103794 -4.373984590555415e-08 -0.09997493465804275 +2.9571000000000005 0.7070631546626603 0.7070618124857095 -4.4449578799361095e-08 -0.09997494227147315 +2.9572000000000003 0.7070631680948523 0.7070618259645693 -4.515878426107969e-08 -0.09997494988259129 +2.9573 0.7070631815153474 0.7070618394469526 -4.586729881306652e-08 -0.0999749574913979 +2.9574000000000003 0.7070631949241564 0.707061852932851 -4.657495918748483e-08 -0.09997496509789368 +2.9575 0.7070632083212915 0.7070618664222543 -4.728160236309965e-08 -0.09997497270207929 +2.9576000000000002 0.7070632217067672 0.7070618799151509 -4.798706560252015e-08 -0.09997498030395546 +2.9577000000000004 0.7070632350805994 0.707061893411528 -4.869118648987564e-08 -0.099974987903523 +2.9578 0.7070632484428059 0.7070619069113699 -4.9393802968003726e-08 -0.09997499550078254 +2.9579 0.7070632617934058 0.7070619204146595 -5.0094753376288964e-08 -0.09997500309573468 +2.958 0.7070632751324203 0.7070619339213782 -5.079387648823045e-08 -0.09997501068838019 +2.9581000000000004 0.7070632884598722 0.7070619474315057 -5.149101154852155e-08 -0.09997501827871977 +2.9582 0.7070633017757864 0.7070619609450199 -5.218599830720226e-08 -0.09997502586675414 +2.9583000000000004 0.707063315080189 0.707061974461897 -5.287867706053363e-08 -0.09997503345248399 +2.9584 0.7070633283731078 0.7070619879821112 -5.356888868515014e-08 -0.09997504103590994 +2.9585 0.7070633416545729 0.7070620015056357 -5.425647467438045e-08 -0.09997504861703281 +2.9586000000000006 0.7070633549246155 0.7070620150324411 -5.4941277177495557e-08 -0.09997505619585326 +2.9587000000000003 0.7070633681832688 0.7070620285624971 -5.562313903158429e-08 -0.09997506377237192 +2.9588 0.7070633814305672 0.7070620420957712 -5.630190380058464e-08 -0.09997507134658958 +2.9589000000000003 0.7070633946665477 0.7070620556322296 -5.697741581236343e-08 -0.09997507891850689 +2.959 0.7070634078912481 0.7070620691718368 -5.7649520189074e-08 -0.09997508648812463 +2.9591000000000003 0.7070634211047082 0.7070620827145553 -5.8318062890090616e-08 -0.09997509405544337 +2.9592 0.7070634343069693 0.7070620962603461 -5.898289074171559e-08 -0.09997510162046389 +2.9593000000000003 0.7070634474980746 0.7070621098091688 -5.96438514720906e-08 -0.09997510918318687 +2.9594 0.707063460678069 0.7070621233609813 -6.03007937497943e-08 -0.09997511674361306 +2.9595 0.7070634738469983 0.7070621369157395 -6.095356721571785e-08 -0.0999751243017431 +2.9596000000000005 0.7070634870049105 0.707062150473398 -6.160202251862673e-08 -0.09997513185757764 +2.9597 0.7070635001518552 0.7070621640339101 -6.224601135050578e-08 -0.09997513941111746 +2.9598 0.7070635132878833 0.707062177597227 -6.288538647669997e-08 -0.09997514696236326 +2.9599 0.7070635264130474 0.7070621911632986 -6.352000177190995e-08 -0.09997515451131563 +2.96 0.7070635395274019 0.7070622047320732 -6.414971225532015e-08 -0.09997516205797535 +2.9601 0.7070635526310021 0.7070622183034975 -6.477437412008916e-08 -0.09997516960234314 +2.9602000000000004 0.7070635657239055 0.7070622318775167 -6.539384476847779e-08 -0.09997517714441963 +2.9603 0.707063578806171 0.7070622454540747 -6.600798284480888e-08 -0.09997518468420555 +2.9604 0.7070635918778583 0.7070622590331134 -6.66166482623555e-08 -0.09997519222170155 +2.9605 0.70706360493903 0.7070622726145737 -6.721970224714269e-08 -0.09997519975690843 +2.9606000000000003 0.7070636179897487 0.7070622861983948 -6.781700735486104e-08 -0.0999752072898268 +2.9607 0.7070636310300793 0.7070622997845146 -6.840842751293374e-08 -0.09997521482045738 +2.9608000000000003 0.7070636440600875 0.7070623133728694 -6.899382804783846e-08 -0.09997522234880084 +2.9609 0.7070636570798415 0.7070623269633939 -6.957307571459764e-08 -0.09997522987485788 +2.961 0.7070636700894101 0.7070623405560219 -7.014603872973826e-08 -0.09997523739862929 +2.9611000000000005 0.7070636830888635 0.7070623541506855 -7.071258679818004e-08 -0.09997524492011567 +2.9612000000000003 0.7070636960782732 0.707062367747315 -7.127259114706255e-08 -0.09997525243931771 +2.9613 0.7070637090577128 0.7070623813458399 -7.182592455046502e-08 -0.09997525995623607 +2.9614000000000003 0.7070637220272565 0.7070623949461885 -7.237246136236608e-08 -0.09997526747087158 +2.9615 0.7070637349869802 0.7070624085482871 -7.291207753962886e-08 -0.09997527498322481 +2.9616000000000002 0.7070637479369606 0.7070624221520612 -7.344465067756281e-08 -0.09997528249329644 +2.9617000000000004 0.7070637608772765 0.7070624357574347 -7.39700600303067e-08 -0.09997529000108724 +2.9618 0.7070637738080077 0.7070624493643309 -7.448818654292103e-08 -0.09997529750659792 +2.9619 0.7070637867292349 0.707062462972671 -7.499891287610777e-08 -0.09997530500982912 +2.962 0.7070637996410398 0.7070624765823749 -7.550212343656812e-08 -0.0999753125107815 +2.9621000000000004 0.7070638125435065 0.707062490193362 -7.599770439695175e-08 -0.09997532000945576 +2.9622 0.7070638254367192 0.7070625038055505 -7.648554372925026e-08 -0.0999753275058527 +2.9623000000000004 0.7070638383207639 0.7070625174188567 -7.696553121737393e-08 -0.09997533499997291 +2.9624 0.7070638511957272 0.7070625310331963 -7.743755849748402e-08 -0.09997534249181708 +2.9625 0.7070638640616973 0.7070625446484833 -7.790151907664106e-08 -0.09997534998138591 +2.9626000000000006 0.7070638769187636 0.7070625582646317 -7.835730835101945e-08 -0.09997535746868019 +2.9627000000000003 0.7070638897670163 0.7070625718815534 -7.880482363366303e-08 -0.09997536495370057 +2.9628 0.7070639026065466 0.7070625854991592 -7.924396417790386e-08 -0.09997537243644765 +2.9629000000000003 0.7070639154374468 0.7070625991173591 -7.967463120511775e-08 -0.09997537991692215 +2.963 0.7070639282598106 0.7070626127360622 -8.009672791426531e-08 -0.09997538739512478 +2.9631000000000003 0.7070639410737323 0.7070626263551765 -8.051015952265789e-08 -0.09997539487105622 +2.9632 0.7070639538793075 0.7070626399746089 -8.091483325901871e-08 -0.09997540234471719 +2.9633000000000003 0.7070639666766323 0.7070626535942657 -8.131065841639196e-08 -0.09997540981610831 +2.9634 0.7070639794658045 0.7070626672140518 -8.169754635040799e-08 -0.09997541728523036 +2.9635 0.7070639922469224 0.7070626808338711 -8.207541050703898e-08 -0.09997542475208399 +2.9636000000000005 0.7070640050200849 0.7070626944536269 -8.244416643387459e-08 -0.09997543221666988 +2.9637000000000002 0.7070640177853924 0.7070627080732218 -8.280373181568379e-08 -0.0999754396789887 +2.9638 0.7070640305429456 0.7070627216925571 -8.31540264787517e-08 -0.09997544713904118 +2.9639 0.7070640432928464 0.7070627353115337 -8.349497241082887e-08 -0.09997545459682804 +2.964 0.7070640560351973 0.7070627489300512 -8.382649378368273e-08 -0.09997546205234985 +2.9641 0.7070640687701016 0.7070627625480084 -8.414851696437325e-08 -0.09997546950560733 +2.9642000000000004 0.7070640814976636 0.7070627761653041 -8.446097053780438e-08 -0.09997547695660125 +2.9643 0.7070640942179884 0.7070627897818358 -8.476378531019346e-08 -0.0999754844053323 +2.9644 0.7070641069311812 0.7070628033975002 -8.505689433942892e-08 -0.0999754918518011 +2.9645 0.7070641196373484 0.7070628170121933 -8.534023294374388e-08 -0.09997549929600835 +2.9646000000000003 0.7070641323365969 0.7070628306258108 -8.561373871212447e-08 -0.09997550673795472 +2.9647 0.7070641450290345 0.7070628442382475 -8.587735152339182e-08 -0.09997551417764096 +2.9648000000000003 0.7070641577147694 0.7070628578493975 -8.61310135566104e-08 -0.0999755216150677 +2.9649 0.7070641703939101 0.7070628714591545 -8.637466930323107e-08 -0.09997552905023564 +2.965 0.707064183066566 0.7070628850674114 -8.660826558270357e-08 -0.09997553648314544 +2.9651000000000005 0.7070641957328476 0.7070628986740612 -8.68317515511502e-08 -0.0999755439137979 +2.9652000000000003 0.7070642083928647 0.7070629122789955 -8.7045078709172e-08 -0.09997555134219357 +2.9653 0.7070642210467282 0.7070629258821057 -8.724820092093077e-08 -0.09997555876833317 +2.9654000000000003 0.7070642336945496 0.707062939483283 -8.744107441588378e-08 -0.09997556619221735 +2.9655 0.707064246336441 0.7070629530824181 -8.762365780699832e-08 -0.0999755736138469 +2.9656000000000002 0.7070642589725145 0.707062966679401 -8.779591208641496e-08 -0.09997558103322245 +2.9657000000000004 0.7070642716028823 0.7070629802741216 -8.795780064279474e-08 -0.09997558845034464 +2.9658 0.7070642842276578 0.7070629938664692 -8.810928927259487e-08 -0.09997559586521415 +2.9659 0.7070642968469545 0.7070630074563333 -8.825034617833405e-08 -0.09997560327783181 +2.966 0.7070643094608857 0.7070630210436024 -8.838094198160285e-08 -0.0999756106881982 +2.9661000000000004 0.7070643220695657 0.707063034628165 -8.850104972653317e-08 -0.09997561809631401 +2.9662 0.7070643346731083 0.7070630482099092 -8.861064488153297e-08 -0.09997562550217991 +2.9663000000000004 0.707064347271628 0.7070630617887232 -8.8709705350562e-08 -0.09997563290579661 +2.9664 0.7070643598652395 0.7070630753644948 -8.879821147833589e-08 -0.09997564030716477 +2.9665 0.7070643724540576 0.7070630889371112 -8.887614604685679e-08 -0.09997564770628509 +2.9666000000000006 0.707064385038197 0.7070631025064602 -8.894349428061749e-08 -0.09997565510315817 +2.9667000000000003 0.7070643976177733 0.7070631160724292 -8.900024385614241e-08 -0.09997566249778482 +2.9668 0.7070644101929012 0.7070631296349055 -8.90463848959161e-08 -0.09997566989016567 +2.9669 0.7070644227636962 0.707063143193776 -8.908190997705678e-08 -0.09997567728030138 +2.967 0.7070644353302733 0.7070631567489276 -8.910681412437754e-08 -0.09997568466819261 +2.9671000000000003 0.707064447892748 0.7070631703002479 -8.912109481472308e-08 -0.09997569205384008 +2.9672 0.707064460451236 0.7070631838476239 -8.912475197783709e-08 -0.09997569943724453 +2.9673000000000003 0.7070644730058524 0.7070631973909425 -8.911778799722964e-08 -0.09997570681840659 +2.9674 0.7070644855567123 0.7070632109300907 -8.910020770237087e-08 -0.0999757141973269 +2.9675 0.7070644981039307 0.707063224464956 -8.907201837302786e-08 -0.09997572157400614 +2.9676000000000005 0.707064510647623 0.7070632379954258 -8.903322973492778e-08 -0.09997572894844509 +2.9677000000000002 0.7070645231879042 0.7070632515213875 -8.898385395195163e-08 -0.09997573632064437 +2.9678 0.7070645357248887 0.7070632650427289 -8.892390563654262e-08 -0.09997574369060463 +2.9679 0.7070645482586913 0.7070632785593376 -8.885340182715473e-08 -0.09997575105832661 +2.968 0.7070645607894261 0.7070632920711019 -8.877236199866106e-08 -0.09997575842381096 +2.9681 0.7070645733172076 0.7070633055779098 -8.868080804674133e-08 -0.09997576578705836 +2.9682000000000004 0.7070645858421492 0.7070633190796498 -8.857876428614714e-08 -0.09997577314806941 +2.9683 0.7070645983643645 0.707063332576211 -8.846625745070197e-08 -0.09997578050684489 +2.9684 0.7070646108839671 0.7070633460674827 -8.834331667335188e-08 -0.09997578786338546 +2.9685 0.7070646234010698 0.7070633595533542 -8.82099734905023e-08 -0.09997579521769183 +2.9686000000000003 0.707064635915785 0.7070633730337152 -8.806626182380345e-08 -0.09997580256976459 +2.9687 0.7070646484282247 0.7070633865084562 -8.791221798361976e-08 -0.09997580991960447 +2.9688000000000003 0.707064660938501 0.707063399977468 -8.774788064908057e-08 -0.09997581726721216 +2.9689 0.7070646734467247 0.7070634134406414 -8.757329086374332e-08 -0.09997582461258832 +2.969 0.707064685953007 0.7070634268978682 -8.73884920234505e-08 -0.09997583195573362 +2.9691000000000005 0.7070646984574578 0.7070634403490402 -8.719352986505391e-08 -0.09997583929664872 +2.9692000000000003 0.7070647109601873 0.7070634537940504 -8.698845246381259e-08 -0.09997584663533436 +2.9693 0.7070647234613048 0.7070634672327922 -8.677331020303519e-08 -0.0999758539717912 +2.9694000000000003 0.7070647359609183 0.707063480665159 -8.65481557792841e-08 -0.09997586130601993 +2.9695 0.7070647484591364 0.7070634940910449 -8.631304418416086e-08 -0.09997586863802115 +2.9696000000000002 0.7070647609560666 0.7070635075103447 -8.606803269303048e-08 -0.09997587596779556 +2.9697000000000005 0.7070647734518155 0.7070635209229549 -8.58131808407353e-08 -0.09997588329534393 +2.9698 0.7070647859464891 0.707063534328771 -8.554855042072762e-08 -0.09997589062066685 +2.9699 0.707064798440193 0.7070635477276899 -8.527420545991621e-08 -0.09997589794376495 +2.97 0.707064810933032 0.7070635611196097 -8.499021220565589e-08 -0.099975905264639 +2.9701000000000004 0.7070648234251102 0.7070635745044282 -8.469663911620656e-08 -0.09997591258328964 +2.9702 0.7070648359165308 0.7070635878820453 -8.439355683818178e-08 -0.09997591989971755 +2.9703000000000004 0.7070648484073958 0.7070636012523603 -8.408103819093626e-08 -0.0999759272139234 +2.9704 0.7070648608978071 0.7070636146152743 -8.375915814401447e-08 -0.09997593452590782 +2.9705 0.7070648733878655 0.707063627970689 -8.342799381021171e-08 -0.09997594183567154 +2.9706000000000006 0.7070648858776711 0.7070636413185065 -8.308762442389012e-08 -0.09997594914321528 +2.9707000000000003 0.7070648983673231 0.7070636546586302 -8.273813130801888e-08 -0.09997595644853963 +2.9708 0.707064910856919 0.7070636679909643 -8.237959787677634e-08 -0.09997596375164523 +2.9709 0.7070649233465567 0.7070636813154143 -8.201210959825345e-08 -0.09997597105253289 +2.971 0.7070649358363323 0.7070636946318859 -8.163575398404538e-08 -0.09997597835120321 +2.9711000000000003 0.7070649483263411 0.7070637079402864 -8.125062056323074e-08 -0.09997598564765689 +2.9712 0.7070649608166775 0.7070637212405235 -8.085680087022845e-08 -0.09997599294189452 +2.9713000000000003 0.7070649733074345 0.7070637345325066 -8.045438840576652e-08 -0.09997600023391685 +2.9714 0.7070649857987049 0.7070637478161457 -8.00434786299431e-08 -0.09997600752372456 +2.9715 0.7070649982905797 0.7070637610913515 -7.962416893273622e-08 -0.09997601481131824 +2.9716000000000005 0.7070650107831491 0.7070637743580366 -7.919655861318708e-08 -0.09997602209669865 +2.9717000000000002 0.7070650232765021 0.7070637876161141 -7.87607488568487e-08 -0.09997602937986638 +2.9718 0.7070650357707271 0.7070638008654986 -7.831684271149969e-08 -0.09997603666082218 +2.9719 0.7070650482659104 0.7070638141061054 -7.78649450567867e-08 -0.09997604393956669 +2.972 0.707065060762138 0.7070638273378512 -7.740516259034658e-08 -0.09997605121610055 +2.9721 0.7070650732594945 0.7070638405606536 -7.693760379137715e-08 -0.09997605849042442 +2.9722000000000004 0.7070650857580634 0.7070638537744323 -7.646237890329005e-08 -0.0999760657625391 +2.9723 0.7070650982579265 0.7070638669791072 -7.59795999059551e-08 -0.09997607303244517 +2.9724 0.707065110759165 0.7070638801745993 -7.548938048534265e-08 -0.09997608030014331 +2.9725 0.7070651232618581 0.7070638933608318 -7.499183601010484e-08 -0.09997608756563414 +2.9726000000000004 0.7070651357660848 0.7070639065377285 -7.44870835059884e-08 -0.0999760948289184 +2.9727 0.7070651482719221 0.7070639197052151 -7.397524162591068e-08 -0.09997610208999679 +2.9728000000000003 0.7070651607794458 0.7070639328632171 -7.345643062090304e-08 -0.09997610934886991 +2.9729 0.7070651732887303 0.7070639460116632 -7.293077231539102e-08 -0.09997611660553843 +2.973 0.7070651857998488 0.707063959150482 -7.239839007727039e-08 -0.099976123860003 +2.9731000000000005 0.7070651983128733 0.7070639722796045 -7.185940878451369e-08 -0.09997613111226439 +2.9732000000000003 0.7070652108278743 0.7070639853989622 -7.131395480435357e-08 -0.09997613836232316 +2.9733 0.7070652233449208 0.7070639985084884 -7.076215595685359e-08 -0.09997614561018003 +2.9734000000000003 0.7070652358640807 0.7070640116081177 -7.020414148498424e-08 -0.09997615285583564 +2.9735 0.7070652483854203 0.7070640246977864 -6.964004203380628e-08 -0.09997616009929072 +2.9736000000000002 0.7070652609090045 0.7070640377774318 -6.906998960536787e-08 -0.09997616734054587 +2.9737000000000005 0.7070652734348966 0.7070640508469925 -6.849411754005635e-08 -0.09997617457960178 +2.9738 0.7070652859631588 0.7070640639064093 -6.791256047583225e-08 -0.09997618181645915 +2.9739 0.7070652984938517 0.7070640769556238 -6.732545432827988e-08 -0.09997618905111862 +2.974 0.7070653110270342 0.7070640899945793 -6.67329362442036e-08 -0.09997619628358084 +2.9741000000000004 0.7070653235627637 0.7070641030232204 -6.613514458297942e-08 -0.09997620351384648 +2.9742 0.7070653361010969 0.7070641160414934 -6.553221887622279e-08 -0.0999762107419162 +2.9743000000000004 0.707065348642088 0.7070641290493462 -6.492429980003295e-08 -0.09997621796779071 +2.9744 0.7070653611857902 0.7070641420467285 -6.431152913769639e-08 -0.09997622519147074 +2.9745 0.707065373732255 0.7070641550335905 -6.369404974976289e-08 -0.09997623241295682 +2.9746000000000006 0.7070653862815324 0.7070641680098848 -6.307200554108577e-08 -0.09997623963224965 +2.9747000000000003 0.7070653988336705 0.7070641809755652 -6.244554142482636e-08 -0.09997624684934991 +2.9748 0.7070654113887165 0.7070641939305875 -6.181480328992794e-08 -0.09997625406425831 +2.9749 0.7070654239467158 0.7070642068749087 -6.117993796598761e-08 -0.09997626127697547 +2.975 0.7070654365077114 0.7070642198084871 -6.054109319506701e-08 -0.09997626848750202 +2.9751000000000003 0.7070654490717458 0.7070642327312835 -5.989841758658951e-08 -0.09997627569583865 +2.9752 0.7070654616388596 0.7070642456432596 -5.925206059262042e-08 -0.09997628290198608 +2.9753000000000003 0.7070654742090916 0.7070642585443787 -5.860217246840202e-08 -0.09997629010594494 +2.9754 0.7070654867824788 0.7070642714346063 -5.794890423744224e-08 -0.09997629730771589 +2.9755 0.707065499359057 0.7070642843139088 -5.7292407657904415e-08 -0.09997630450729955 +2.9756000000000005 0.7070655119388602 0.7070642971822547 -5.663283518747911e-08 -0.09997631170469666 +2.9757000000000002 0.7070655245219206 0.7070643100396141 -5.5970339945653896e-08 -0.09997631889990785 +2.9758 0.7070655371082688 0.7070643228859586 -5.53050756822715e-08 -0.09997632609293378 +2.9759 0.7070655496979339 0.7070643357212616 -5.4637196737414295e-08 -0.0999763332837751 +2.976 0.7070655622909432 0.7070643485454984 -5.396685800736038e-08 -0.09997634047243253 +2.9761 0.7070655748873224 0.7070643613586453 -5.32942149098891e-08 -0.0999763476589067 +2.9762000000000004 0.7070655874870955 0.7070643741606808 -5.2619423348068683e-08 -0.09997635484319828 +2.9763 0.7070656000902846 0.7070643869515847 -5.194263967165866e-08 -0.09997636202530791 +2.9764 0.7070656126969107 0.7070643997313388 -5.126402064263222e-08 -0.09997636920523623 +2.9765 0.7070656253069925 0.7070644124999269 -5.058372340243332e-08 -0.09997637638298398 +2.9766000000000004 0.7070656379205473 0.7070644252573337 -4.9901905426765446e-08 -0.09997638355855178 +2.9767 0.7070656505375905 0.7070644380035462 -4.9218724498052875e-08 -0.09997639073194027 +2.9768000000000003 0.707065663158136 0.7070644507385526 -4.853433866348206e-08 -0.09997639790315013 +2.9769 0.7070656757821963 0.7070644634623436 -4.7848906201716605e-08 -0.09997640507218204 +2.977 0.7070656884097812 0.7070644761749107 -4.7162585582998656e-08 -0.09997641223903665 +2.9771000000000005 0.7070657010408998 0.7070644888762476 -4.6475535436189125e-08 -0.0999764194037146 +2.9772000000000003 0.7070657136755591 0.7070645015663495 -4.5787914509140114e-08 -0.09997642656621654 +2.9773 0.7070657263137647 0.7070645142452133 -4.509988163465097e-08 -0.09997643372654318 +2.9774000000000003 0.7070657389555199 0.7070645269128382 -4.441159569067805e-08 -0.09997644088469516 +2.9775 0.7070657516008266 0.7070645395692243 -4.372321556561317e-08 -0.09997644804067314 +2.9776000000000002 0.7070657642496849 0.7070645522143738 -4.303490012247781e-08 -0.09997645519447776 +2.9777000000000005 0.7070657769020936 0.7070645648482905 -4.234680816084729e-08 -0.09997646234610968 +2.9778000000000002 0.7070657895580497 0.7070645774709801 -4.1659098379601654e-08 -0.09997646949556968 +2.9779 0.7070658022175478 0.7070645900824495 -4.0971929341838183e-08 -0.09997647664285826 +2.978 0.7070658148805813 0.7070646026827079 -4.028545943796785e-08 -0.09997648378797613 +2.9781000000000004 0.7070658275471419 0.7070646152717659 -3.9599846848262926e-08 -0.09997649093092395 +2.9782 0.7070658402172199 0.707064627849636 -3.891524950872492e-08 -0.09997649807170242 +2.9783000000000004 0.7070658528908034 0.707064640416332 -3.823182507145702e-08 -0.09997650521031214 +2.9784 0.7070658655678789 0.7070646529718696 -3.754973087013221e-08 -0.09997651234675377 +2.9785 0.7070658782484314 0.7070646655162665 -3.686912388573254e-08 -0.09997651948102802 +2.9786000000000006 0.7070658909324443 0.7070646780495415 -3.619016070567464e-08 -0.09997652661313555 +2.9787000000000003 0.7070659036198992 0.7070646905717155 -3.5512997493126856e-08 -0.09997653374307695 +2.9788 0.7070659163107755 0.7070647030828107 -3.48377899462432e-08 -0.09997654087085289 +2.9789 0.7070659290050518 0.7070647155828513 -3.416469326628785e-08 -0.09997654799646408 +2.979 0.7070659417027048 0.7070647280718634 -3.349386212001329e-08 -0.09997655511991112 +2.9791000000000003 0.7070659544037091 0.7070647405498742 -3.282545060377326e-08 -0.09997656224119475 +2.9792 0.7070659671080382 0.7070647530169127 -3.21596122095872e-08 -0.09997656936031556 +2.9793000000000003 0.7070659798156633 0.7070647654730096 -3.149649978957843e-08 -0.09997657647727419 +2.9794 0.7070659925265548 0.7070647779181971 -3.083626551976179e-08 -0.09997658359207129 +2.9795 0.7070660052406809 0.7070647903525097 -3.017906086599971e-08 -0.0999765907047076 +2.9796000000000005 0.7070660179580086 0.7070648027759825 -2.9525036549524555e-08 -0.09997659781518378 +2.9797000000000002 0.7070660306785026 0.7070648151886529 -2.8874342510943132e-08 -0.09997660492350038 +2.9798 0.7070660434021265 0.7070648275905596 -2.8227127877276936e-08 -0.09997661202965813 +2.9799 0.7070660561288425 0.707064839981743 -2.7583540929002406e-08 -0.09997661913365766 +2.98 0.7070660688586111 0.707064852362245 -2.694372906210385e-08 -0.09997662623549967 +2.9801 0.7070660815913907 0.7070648647321092 -2.630783875814946e-08 -0.09997663333518475 +2.9802000000000004 0.7070660943271383 0.7070648770913806 -2.5676015550247372e-08 -0.09997664043271354 +2.9803 0.7070661070658102 0.7070648894401059 -2.5048403986399626e-08 -0.09997664752808676 +2.9804 0.7070661198073602 0.7070649017783334 -2.442514760066239e-08 -0.09997665462130507 +2.9805 0.7070661325517411 0.7070649141061125 -2.380638887931885e-08 -0.09997666171236909 +2.9806000000000004 0.7070661452989038 0.7070649264234947 -2.3192269226618434e-08 -0.09997666880127946 +2.9807 0.7070661580487976 0.7070649387305328 -2.2582928934419128e-08 -0.09997667588803683 +2.9808000000000003 0.707066170801371 0.7070649510272807 -2.1978507147493026e-08 -0.0999766829726419 +2.9809 0.7070661835565704 0.7070649633137944 -2.1379141833602344e-08 -0.09997669005509527 +2.981 0.707066196314341 0.707064975590131 -2.0784969753141758e-08 -0.09997669713539764 +2.9811000000000005 0.7070662090746265 0.7070649878563493 -2.01961264274797e-08 -0.09997670421354965 +2.9812000000000003 0.7070662218373691 0.7070650001125093 -1.9612746106865975e-08 -0.09997671128955196 +2.9813 0.70706623460251 0.7070650123586726 -1.903496173833938e-08 -0.0999767183634053 +2.9814000000000003 0.707066247369988 0.7070650245949015 -1.846290493883948e-08 -0.09997672543511016 +2.9815 0.7070662601397413 0.707065036821261 -1.789670596311424e-08 -0.09997673250466727 +2.9816000000000003 0.7070662729117065 0.7070650490378163 -1.7336493675964432e-08 -0.09997673957207727 +2.9817000000000005 0.7070662856858193 0.7070650612446346 -1.6782395521018623e-08 -0.09997674663734087 +2.9818000000000002 0.7070662984620131 0.7070650734417845 -1.6234537492110235e-08 -0.09997675370045865 +2.9819 0.7070663112402205 0.7070650856293352 -1.5693044104220927e-08 -0.09997676076143126 +2.982 0.7070663240203726 0.7070650978073583 -1.5158038369628146e-08 -0.09997676782025934 +2.9821000000000004 0.7070663368023999 0.7070651099759262 -1.4629641761042256e-08 -0.09997677487694365 +2.9822 0.7070663495862306 0.7070651221351122 -1.4107974193825618e-08 -0.09997678193148472 +2.9823000000000004 0.7070663623717921 0.7070651342849914 -1.3593153993900209e-08 -0.09997678898388326 +2.9824 0.7070663751590107 0.7070651464256397 -1.3085297868257323e-08 -0.09997679603413988 +2.9825 0.7070663879478113 0.7070651585571348 -1.258452088544193e-08 -0.09997680308225526 +2.9826000000000006 0.7070664007381178 0.7070651706795554 -1.2090936439990846e-08 -0.09997681012823009 +2.9827000000000004 0.7070664135298523 0.7070651827929808 -1.1604656236820221e-08 -0.09997681717206497 +2.9828 0.7070664263229365 0.7070651948974924 -1.1125790263469965e-08 -0.09997682421376056 +2.9829 0.7070664391172901 0.707065206993172 -1.0654446760613445e-08 -0.09997683125331747 +2.983 0.7070664519128325 0.7070652190801034 -1.0190732200807129e-08 -0.09997683829073643 +2.9831000000000003 0.7070664647094814 0.7070652311583709 -9.734751262903407e-09 -0.09997684532601807 +2.9832 0.7070664775071537 0.7070652432280596 -9.286606810800235e-09 -0.099976852359163 +2.9833000000000003 0.7070664903057648 0.7070652552892562 -8.846399865251875e-09 -0.09997685939017184 +2.9834 0.7070665031052301 0.7070652673420489 -8.414229593460554e-09 -0.09997686641904538 +2.9835 0.7070665159054623 0.707065279386526 -7.990193269177825e-09 -0.09997687344578417 +2.9836000000000005 0.7070665287063747 0.7070652914227769 -7.57438626316359e-09 -0.09997688047038883 +2.9837000000000002 0.7070665415078781 0.7070653034508925 -7.166902020634691e-09 -0.09997688749286 +2.9838 0.7070665543098839 0.7070653154709646 -6.767832036111421e-09 -0.0999768945131984 +2.9839 0.7070665671123012 0.707065327483086 -6.377265834335566e-09 -0.09997690153140468 +2.984 0.7070665799150389 0.7070653394873502 -5.995290951188448e-09 -0.0999769085474794 +2.9841 0.7070665927180046 0.7070653514838513 -5.621992918078411e-09 -0.09997691556142323 +2.9842000000000004 0.7070666055211055 0.7070653634726849 -5.25745522984844e-09 -0.09997692257323683 +2.9843 0.7070666183242474 0.7070653754539477 -4.901759339571987e-09 -0.09997692958292093 +2.9844 0.7070666311273357 0.7070653874277363 -4.554984634266845e-09 -0.09997693659047607 +2.9845 0.7070666439302745 0.7070653993941489 -4.217208420149998e-09 -0.09997694359590294 +2.9846000000000004 0.7070666567329673 0.707065411353284 -3.888505903555661e-09 -0.09997695059920216 +2.9847 0.7070666695353174 0.7070654233052415 -3.5689501761901332e-09 -0.09997695760037444 +2.9848000000000003 0.7070666823372262 0.7070654352501217 -3.2586121908456667e-09 -0.09997696459942043 +2.9849 0.7070666951385954 0.7070654471880251 -2.957560756196298e-09 -0.0999769715963407 +2.985 0.7070667079393251 0.7070654591190539 -2.665862514246442e-09 -0.09997697859113588 +2.9851000000000005 0.7070667207393154 0.7070654710433102 -2.3835819325246366e-09 -0.09997698558380667 +2.9852000000000003 0.7070667335384657 0.7070654829608973 -2.1107812858689456e-09 -0.09997699257435375 +2.9853 0.7070667463366741 0.707065494871919 -1.8475206416818102e-09 -0.09997699956277771 +2.9854000000000003 0.7070667591338388 0.7070655067764795 -1.5938578460522601e-09 -0.09997700654907918 +2.9855 0.7070667719298571 0.7070655186746835 -1.3498485124802118e-09 -0.09997701353325883 +2.9856000000000003 0.7070667847246259 0.7070655305666371 -1.1155460140702123e-09 -0.09997702051531732 +2.9857000000000005 0.7070667975180412 0.7070655424524459 -8.910014679189282e-10 -0.09997702749525529 +2.9858000000000002 0.7070668103099991 0.7070655543322164 -6.762637195026344e-10 -0.09997703447307335 +2.9859 0.707066823100394 0.7070655662060559 -4.713793409424905e-10 -0.09997704144877215 +2.986 0.7070668358891214 0.707065578074072 -2.763926171267528e-10 -0.09997704842235235 +2.9861000000000004 0.7070668486760754 0.7070655899363725 -9.134552923090178e-11 -0.09997705539381462 +2.9862 0.7070668614611496 0.7070656017930659 8.372224094554959e-11 -0.09997706236315954 +2.9863000000000004 0.7070668742442378 0.7070656136442609 2.487733283262905e-10 -0.09997706933038777 +2.9864 0.7070668870252328 0.7070656254900667 4.0377268455821236e-10 -0.09997707629549996 +2.9865 0.7070668998040278 0.7070656373305932 5.486876040322608e-10 -0.09997708325849686 +2.9866 0.7070669125805151 0.70706564916595 6.834877082709245e-10 -0.099977090219379 +2.9867000000000004 0.7070669253545865 0.7070656609962471 8.081449650101935e-10 -0.09997709717814703 +2.9868 0.7070669381261341 0.7070656728215949 9.226336916690059e-10 -0.0999771041348016 +2.9869 0.7070669508950493 0.7070656846421044 1.026930558818695e-09 -0.09997711108934333 +2.987 0.7070669636612237 0.707065696457886 1.1210145936524363e-09 -0.09997711804177288 +2.9871000000000003 0.7070669764245484 0.707065708269051 1.2048671869241412e-09 -0.09997712499209091 +2.9872 0.7070669891849144 0.7070657200757107 1.2784721024894363e-09 -0.099977131940298 +2.9873000000000003 0.7070670019422125 0.7070657318779763 1.3418154608257904e-09 -0.09997713888639484 +2.9874 0.7070670146963336 0.7070657436759598 1.3948857659207281e-09 -0.09997714583038213 +2.9875 0.7070670274471684 0.7070657554697724 1.4376738879245954e-09 -0.09997715277226041 +2.9876000000000005 0.7070670401946073 0.7070657672595257 1.4701730787630707e-09 -0.09997715971203036 +2.9877000000000002 0.707067052938541 0.7070657790453316 1.4923789625961859e-09 -0.09997716664969257 +2.9878 0.70706706567886 0.7070657908273018 1.5042895366856879e-09 -0.09997717358524777 +2.9879000000000002 0.7070670784154549 0.7070658026055481 1.5059051818033797e-09 -0.09997718051869658 +2.988 0.7070670911482162 0.707065814380182 1.4972286483533326e-09 -0.09997718745003958 +2.9881 0.7070671038770342 0.7070658261513154 1.4782650641781414e-09 -0.09997719437927742 +2.9882000000000004 0.7070671166018001 0.7070658379190596 1.4490219276200311e-09 -0.09997720130641079 +2.9883 0.7070671293224048 0.7070658496835263 1.4095091049187713e-09 -0.09997720823144035 +2.9884 0.7070671420387391 0.7070658614448269 1.3597388328137616e-09 -0.09997721515436675 +2.9885 0.7070671547506939 0.707065873203072 1.299725706400967e-09 -0.09997722207519051 +2.9886000000000004 0.7070671674581608 0.7070658849583729 1.2294866843370889e-09 -0.09997722899391236 +2.9887 0.7070671801610311 0.7070658967108403 1.149041079298585e-09 -0.09997723591053292 +2.9888000000000003 0.7070671928591966 0.7070659084605846 1.058410546705968e-09 -0.09997724282505278 +2.9889 0.7070672055525493 0.7070659202077161 9.57619095132145e-10 -0.09997724973747263 +2.989 0.7070672182409814 0.7070659319523445 8.46693060281567e-10 -0.09997725664779304 +2.9891000000000005 0.707067230924386 0.7070659436945801 7.256611162659299e-10 -0.09997726355601477 +2.9892000000000003 0.7070672436026555 0.7070659554345318 5.945542591243025e-10 -0.09997727046213839 +2.9893 0.7070672562756832 0.7070659671723085 4.5340579554742355e-10 -0.09997727736616452 +2.9894000000000003 0.707067268943363 0.7070659789080189 3.0225134287770183e-10 -0.09997728426809377 +2.9895 0.707067281605589 0.7070659906417707 1.411288134967048e-10 -0.09997729116792678 +2.9896000000000003 0.7070672942622558 0.7070660023736722 -2.9921586042203074e-11 -0.09997729806566429 +2.9897000000000005 0.7070673069132585 0.7070660141038305 -2.108573758305421e-10 -0.09997730496130686 +2.9898000000000002 0.707067319558492 0.7070660258323521 -4.0163380694152595e-10 -0.09997731185485509 +2.9899 0.707067332197853 0.7070660375593435 -6.022038727057644e-10 -0.0999773187463097 +2.99 0.7070673448312379 0.7070660492849103 -8.125183217216891e-10 -0.09997732563567129 +2.9901000000000004 0.7070673574585435 0.7070660610091579 -1.032525668263895e-09 -0.09997733252294051 +2.9902 0.7070673700796679 0.7070660727321907 -1.262172207895651e-09 -0.09997733940811802 +2.9903000000000004 0.7070673826945089 0.7070660844541126 -1.5014020261425176e-09 -0.09997734629120436 +2.9904 0.7070673953029654 0.707066096175027 -1.7501570141048584e-09 -0.0999773531722002 +2.9905 0.7070674079049372 0.7070661078950368 -2.008376880600904e-09 -0.09997736005110625 +2.9906 0.7070674205003245 0.7070661196142438 -2.2759991747181574e-09 -0.0999773669279231 +2.9907000000000004 0.7070674330890281 0.7070661313327494 -2.5529592918849264e-09 -0.09997737380265134 +2.9908 0.7070674456709496 0.707066143050654 -2.8391904938196433e-09 -0.0999773806752916 +2.9909 0.7070674582459917 0.7070661547680579 -3.134623920673929e-09 -0.09997738754584462 +2.991 0.7070674708140572 0.7070661664850599 -3.4391886083798284e-09 -0.09997739441431096 +2.9911000000000003 0.7070674833750503 0.7070661782017582 -3.752811518140109e-09 -0.09997740128069124 +2.9912 0.7070674959288754 0.7070661899182504 -4.075417529489367e-09 -0.09997740814498608 +2.9913000000000003 0.7070675084754383 0.7070662016346332 -4.406929481060029e-09 -0.09997741500719615 +2.9914 0.7070675210146455 0.7070662133510025 -4.747268175786523e-09 -0.09997742186732211 +2.9915 0.7070675335464041 0.7070662250674532 -5.096352407793492e-09 -0.09997742872536454 +2.9916000000000005 0.7070675460706223 0.7070662367840793 -5.454098974538857e-09 -0.0999774355813241 +2.9917000000000002 0.7070675585872093 0.7070662485009738 -5.820422702834671e-09 -0.09997744243520139 +2.9918 0.7070675710960753 0.7070662602182288 -6.195236465326992e-09 -0.09997744928699707 +2.9919000000000002 0.7070675835971314 0.7070662719359359 -6.578451200445201e-09 -0.09997745613671179 +2.992 0.7070675960902895 0.707066283654185 -6.969975935820771e-09 -0.09997746298434619 +2.9921 0.7070676085754625 0.7070662953730658 -7.369717808236587e-09 -0.0999774698299009 +2.9922000000000004 0.7070676210525642 0.7070663070926658 -7.777582089647794e-09 -0.09997747667337648 +2.9923 0.7070676335215103 0.7070663188130728 -8.19347220452904e-09 -0.09997748351477365 +2.9924 0.7070676459822163 0.7070663305343727 -8.617289758497404e-09 -0.099977490354093 +2.9925 0.7070676584345996 0.7070663422566503 -9.048934550455467e-09 -0.09997749719133514 +2.9926000000000004 0.7070676708785786 0.7070663539799895 -9.488304609020504e-09 -0.0999775040265007 +2.9927 0.7070676833140725 0.7070663657044735 -9.935296212473799e-09 -0.09997751085959032 +2.9928000000000003 0.7070676957410023 0.707066377430184 -1.0389803906975248e-08 -0.0999775176906047 +2.9929 0.7070677081592891 0.7070663891572011 -1.0851720542125187e-08 -0.09997752451954436 +2.993 0.707067720568856 0.7070664008856042 -1.1320937287877947e-08 -0.09997753134640995 +2.9931000000000005 0.7070677329696273 0.7070664126154715 -1.1797343660996384e-08 -0.09997753817120211 +2.9932000000000003 0.7070677453615284 0.7070664243468804 -1.2280827555409546e-08 -0.0999775449939216 +2.9933 0.7070677577444853 0.7070664360799064 -1.2771275265197751e-08 -0.09997755181456891 +2.9934000000000003 0.7070677701184257 0.7070664478146238 -1.326857151191449e-08 -0.09997755863314466 +2.9935 0.707067782483279 0.7070664595511058 -1.3772599472341995e-08 -0.09997756544964953 +2.9936000000000003 0.7070677948389752 0.7070664712894246 -1.4283240805813141e-08 -0.09997757226408412 +2.9937000000000005 0.7070678071854463 0.7070664830296509 -1.4800375681099653e-08 -0.09997757907644911 +2.9938000000000002 0.7070678195226248 0.7070664947718539 -1.532388280503505e-08 -0.0999775858867451 +2.9939 0.7070678318504446 0.7070665065161015 -1.5853639450270213e-08 -0.09997759269497271 +2.994 0.7070678441688417 0.7070665182624605 -1.6389521486498415e-08 -0.09997759950113255 +2.9941000000000004 0.707067856477753 0.7070665300109965 -1.6931403404307765e-08 -0.09997760630522533 +2.9942 0.7070678687771165 0.7070665417617732 -1.7479158352911445e-08 -0.09997761310725156 +2.9943 0.7070678810668716 0.7070665535148534 -1.803265816183175e-08 -0.09997761990721192 +2.9944 0.7070678933469596 0.7070665652702982 -1.8591773373426157e-08 -0.09997762670510707 +2.9945 0.7070679056173229 0.7070665770281674 -1.915637327541339e-08 -0.09997763350093757 +2.9946 0.7070679178779053 0.7070665887885195 -1.9726325927327953e-08 -0.09997764029470411 +2.9947000000000004 0.707067930128652 0.7070666005514114 -2.0301498198684043e-08 -0.09997764708640729 +2.9948 0.7070679423695099 0.7070666123168985 -2.0881755788924872e-08 -0.09997765387604773 +2.9949 0.7070679546004267 0.7070666240850347 -2.1466963269056033e-08 -0.09997766066362604 +2.995 0.7070679668213526 0.707066635855873 -2.2056984106365307e-08 -0.0999776674491429 +2.9951000000000003 0.7070679790322385 0.7070666476294643 -2.2651680701285537e-08 -0.0999776742325989 +2.9952 0.7070679912330367 0.7070666594058583 -2.3250914416451246e-08 -0.09997768101399465 +2.9953000000000003 0.7070680034237018 0.7070666711851028 -2.385454560835734e-08 -0.09997768779333081 +2.9954 0.7070680156041891 0.707066682967245 -2.4462433663788308e-08 -0.099977694570608 +2.9955 0.7070680277744559 0.7070666947523294 -2.507443702757378e-08 -0.09997770134582688 +2.9956000000000005 0.7070680399344609 0.7070667065403998 -2.5690413239451426e-08 -0.09997770811898801 +2.9957000000000003 0.707068052084164 0.7070667183314983 -2.631021896355723e-08 -0.09997771489009204 +2.9958 0.7070680642235272 0.7070667301256649 -2.6933710027456786e-08 -0.09997772165913955 +2.9959000000000002 0.7070680763525139 0.7070667419229392 -2.7560741449033505e-08 -0.09997772842613128 +2.996 0.7070680884710888 0.7070667537233579 -2.8191167474435688e-08 -0.09997773519106778 +2.9961 0.7070681005792183 0.7070667655269569 -2.882484161125312e-08 -0.09997774195394965 +2.9962000000000004 0.7070681126768705 0.7070667773337705 -2.9461616660826292e-08 -0.0999777487147775 +2.9963 0.7070681247640149 0.7070667891438313 -3.010134475532611e-08 -0.099977755473552 +2.9964 0.7070681368406233 0.7070668009571701 -3.074387738876208e-08 -0.09997776223027383 +2.9965 0.707068148906668 0.7070668127738164 -3.138906545449571e-08 -0.0999777689849435 +2.9966000000000004 0.7070681609621237 0.7070668245937979 -3.2036759278850774e-08 -0.09997777573756168 +2.9967 0.7070681730069659 0.7070668364171409 -3.268680865298884e-08 -0.099977782488129 +2.9968000000000004 0.7070681850411729 0.7070668482438696 -3.333906287237426e-08 -0.09997778923664606 +2.9969 0.7070681970647239 0.707066860074007 -3.399337076734864e-08 -0.09997779598311349 +2.997 0.7070682090775997 0.7070668719075747 -3.464958074281266e-08 -0.09997780272753197 +2.9971000000000005 0.7070682210797827 0.707066883744592 -3.530754081010161e-08 -0.09997780946990202 +2.9972000000000003 0.7070682330712572 0.7070668955850772 -3.5967098622330385e-08 -0.09997781621022434 +2.9973 0.7070682450520094 0.7070669074290468 -3.662810150952163e-08 -0.09997782294849959 +2.9974000000000003 0.7070682570220264 0.7070669192765151 -3.7290396515685456e-08 -0.09997782968472832 +2.9975 0.7070682689812974 0.7070669311274951 -3.7953830433839174e-08 -0.09997783641891111 +2.9976000000000003 0.7070682809298132 0.7070669429819982 -3.8618249838316514e-08 -0.09997784315104866 +2.9977000000000005 0.7070682928675661 0.707066954840035 -3.928350112477469e-08 -0.09997784988114158 +2.9978000000000002 0.7070683047945503 0.7070669667016127 -3.994943054179889e-08 -0.09997785660919047 +2.9979 0.7070683167107616 0.7070669785667383 -4.0615884230367234e-08 -0.09997786333519597 +2.998 0.7070683286161972 0.7070669904354163 -4.1282708255455276e-08 -0.09997787005915867 +2.9981000000000004 0.7070683405108561 0.7070670023076497 -4.1949748644335436e-08 -0.09997787678107918 +2.9982 0.7070683523947392 0.7070670141834405 -4.261685141998398e-08 -0.09997788350095818 +2.9983 0.7070683642678489 0.7070670260627885 -4.3283862638919686e-08 -0.09997789021879627 +2.9984 0.7070683761301888 0.7070670379456915 -4.3950628424854754e-08 -0.09997789693459402 +2.9985 0.7070683879817645 0.7070670498321463 -4.461699500501559e-08 -0.09997790364835207 +2.9986 0.707068399822584 0.7070670617221477 -4.528280874460688e-08 -0.09997791036007109 +2.9987000000000004 0.7070684116526558 0.7070670736156892 -4.5947916185219446e-08 -0.09997791706975169 +2.9988 0.7070684234719904 0.7070670855127621 -4.661216407541831e-08 -0.09997792377739441 +2.9989 0.7070684352805999 0.7070670974133564 -4.7275399410126335e-08 -0.09997793048299992 +2.999 0.7070684470784985 0.7070671093174604 -4.793746946347554e-08 -0.09997793718656883 +2.9991000000000003 0.7070684588657018 0.7070671212250612 -4.859822182602235e-08 -0.09997794388810183 +2.9992 0.7070684706422268 0.7070671331361436 -4.925750443814103e-08 -0.0999779505875995 +2.9993000000000003 0.7070684824080922 0.7070671450506907 -4.9915165624067614e-08 -0.09997795728506242 +2.9994 0.7070684941633181 0.7070671569686846 -5.0571054130551726e-08 -0.09997796398049118 +2.9995 0.7070685059079269 0.7070671688901053 -5.122501915797318e-08 -0.09997797067388645 +2.9996000000000005 0.7070685176419423 0.7070671808149316 -5.187691039612065e-08 -0.09997797736524888 +2.9997000000000003 0.7070685293653893 0.7070671927431402 -5.252657805931982e-08 -0.09997798405457903 +2.9998 0.707068541078295 0.7070672046747066 -5.317387292156153e-08 -0.09997799074187752 +2.9999000000000002 0.7070685527806873 0.7070672166096044 -5.381864634675104e-08 -0.09997799742714493 diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh b/examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh new file mode 100755 index 0000000000..15de8d350e --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh @@ -0,0 +1,19 @@ +#!/bin/bash + +# clean old res +rm res_*.dat + +# compute Lammps +./../../../../src/lmp_serial \ + -in bench-spin-precession.in +in="$(grep -n Step log.lammps | awk -F ':' '{print $1}')" +en="$(grep -n Loop log.lammps | awk -F ':' '{print $1}')" +in="$(echo "$in+1" | bc -l)" +en="$(echo "$en-$in" | bc -l)" +tail -n +$in log.lammps | head -n $en > res_lammps.dat + +# compute Langevin +python3 -m llg_exchange.py > res_llg.dat + +# plot results +python3 -m plot_precession.py res_lammps.dat res_llg.dat diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data b/examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data new file mode 100644 index 0000000000..013f813751 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data @@ -0,0 +1,22 @@ +LAMMPS data file via write_data, version 19 Sep 2019, timestep = 0 + +2 atoms +1 atom types + +0.0 6.0 xlo xhi +0.0 3.0 ylo yhi +0.0 3.0 zlo zhi + +Masses + +1 1 + +Atoms # spin + +1 1 2.0 0.0 0.0 0.0 1.0 0.0 0.0 0 0 0 +2 1 2.0 3.0 0.0 0.0 0.0 1.0 0.0 0 0 0 + +Velocities + +1 0.0 0.0 0.0 +2 0.0 0.0 0.0 diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in b/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in new file mode 100644 index 0000000000..37d1e3765a --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in @@ -0,0 +1,48 @@ +#LAMMPS in.run + +units metal +atom_style spin +atom_modify map array +boundary p p p + +# read_data singlespin.data + +lattice sc 3.0 +region box block 0.0 1.0 0.0 1.0 0.0 1.0 +create_box 1 box +create_atoms 1 box + +mass 1 1.0 +set type 1 spin 2.0 1.0 0.0 0.0 + +# defines a pair/style for neighbor list, but do not use it +pair_style spin/exchange 4.0 +pair_coeff * * exchange 1.0 0.0 0.0 1.0 + +group bead type 1 + +variable H equal 10.0 +variable Kan equal 0.0 +variable Temperature equal 0.0 +variable RUN equal 100000 + +fix 1 all nve/spin lattice no +fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 +fix_modify 2 energy yes +fix 3 all langevin/spin ${Temperature} 0.01 12345 + +compute out_mag all spin +compute out_pe all pe + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] + +thermo_style custom step time v_magx v_magy v_magz v_emag pe etotal +thermo 100 + +timestep 0.0001 + +run ${RUN} diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py b/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py new file mode 100755 index 0000000000..edaa4f22cc --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py @@ -0,0 +1,51 @@ +#!/usr/bin/env python3 + +import numpy as np , pylab, tkinter +import math +import matplotlib.pyplot as plt +import mpmath as mp + +mub=5.78901e-5 # Bohr magneton (eV/T) +hbar=0.658212 # Planck's constant (eV.fs/rad) +g=2.0 # Lande factor (adim) +gyro=g*mub/hbar # gyromag ratio (rad/fs/T) +alpha=0.01 # damping coefficient +pi=math.pi + +Bnrm=10.0 # mag. field (T) +Bext = np.array([0.0, 0.0, 1.0]) +Sn = 2.0 # spin norm (in # of muB) +S = np.array([1.0, 0.0, 0.0]) + +N=100000 # number of timesteps +dt=0.1 # timestep (fs) + +# Rodrigues rotation formula +def rotation_matrix(axis, theta): + """ + Return the rotation matrix associated with counterclockwise + rotation about the given axis by theta radians + """ + axis = np.asarray(axis) + a = math.cos(theta / 2.0) + b, c, d = -axis * math.sin(theta / 2.0) + aa, bb, cc, dd = a * a, b * b, c * c, d * d + bc, ad, ac, ab, bd, cd = b * c, a * d, a * c, a * b, b * d, c * d + return np.array([[aa + bb - cc - dd, 2 * (bc + ad), 2 * (bd - ac)], + [2 * (bc - ad), aa + cc - bb - dd, 2 * (cd + ab)], + [2 * (bd + ac), 2 * (cd - ab), aa + dd - bb - cc]]) + +# calc. precession field +def calc_rot_vector(Fi,Sp): + rot = gyro*Sn*Bnrm*(Fi-alpha*np.cross(Fi,Sp)) + return rot + +# np.set_printoptions(precision=4) +for t in range (0,N): + wf = calc_rot_vector(Bext,S) + theta=dt*np.linalg.norm(wf) + axis=wf/np.linalg.norm(wf) + S = np.dot(rotation_matrix(axis, theta), S) + # print res. in ps for comparison with LAMMPS + print(t*dt/1000.0,S[0],S[1],S[2]) + diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py b/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py new file mode 100755 index 0000000000..c15d6c0ff5 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py @@ -0,0 +1,39 @@ +#!/usr/bin/env python3 + +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +from scipy.optimize import curve_fit +from decimal import * +import sys, string, os + + +argv = sys.argv +if len(argv) != 3: + print("Syntax: ./plot_precession.py res_lammps.dat res_llg.dat") + sys.exit() + +lammps_file = sys.argv[1] +llg_file = sys.argv[2] + +t_lmp,Sx_lmp,Sy_lmp,Sz_lmp = np.loadtxt(lammps_file, skiprows=0, usecols=(1,2,3,4),unpack=True) +t_llg,Sx_llg,Sy_llg,Sz_llg = np.loadtxt(llg_file, skiprows=0, usecols=(0,1,2,3),unpack=True) + +plt.figure() +plt.subplot(311) +plt.ylabel('Sx') +plt.plot(t_lmp, Sx_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sx_llg, 'r--', label='LLG') + +plt.subplot(312) +plt.ylabel('Sy') +plt.plot(t_lmp, Sy_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sy_llg, 'r--', label='LLG') + +plt.subplot(313) +plt.ylabel('Sz') +plt.plot(t_lmp, Sz_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, Sz_llg, 'r--', label='LLG') + +plt.xlabel('time (in ps)') +plt.legend() +plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh b/examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh new file mode 100755 index 0000000000..49ebc2ac4e --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh @@ -0,0 +1,19 @@ +#!/bin/bash + +# clean old res +rm res_*.dat + +# compute Lammps +./../../../../src/lmp_serial \ + -in bench-spin-precession.in +in="$(grep -n Step log.lammps | awk -F ':' '{print $1}')" +en="$(grep -n Loop log.lammps | awk -F ':' '{print $1}')" +in="$(echo "$in+1" | bc -l)" +en="$(echo "$en-$in" | bc -l)" +tail -n +$in log.lammps | head -n $en > res_lammps.dat + +# compute Langevin +python3 -m llg_precession.py > res_llg.dat + +# plot results +python3 -m plot_precession.py res_lammps.dat res_llg.dat diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template b/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template new file mode 100644 index 0000000000..c4286e3597 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template @@ -0,0 +1,41 @@ +#LAMMPS in.run + +units metal +atom_style spin +atom_modify map array +boundary p p p + +lattice sc 3.0 +region box block 0.0 2.0 0.0 2.0 0.0 2.0 +create_box 1 box +create_atoms 1 box + +mass 1 1.0 +set type 1 spin 1.0 0.0 0.0 1.0 + +# defines a pair/style for neighbor list, but do not use it +pair_style spin/exchange 3.1 +pair_coeff * * exchange 3.1 11.254 0.0 1.0 + +variable H equal 0.0 +variable Kan equal 0.0 +variable Temperature equal temperature +variable RUN equal 100000 + +fix 1 all nve/spin lattice no +fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 +fix 3 all langevin/spin ${Temperature} 0.01 12345 + +thermo 500000 +thermo_style custom step time temp vol +timestep 0.1 + +compute compute_spin all spin +variable mag_energy equal c_compute_spin[5] +variable AVEs equal c_compute_spin[4] + +fix avespin all ave/time 1 ${RUN} ${RUN} v_Temperature v_H v_Kan v_AVEs v_mag_energy file _av_spin + +run ${RUN} + +shell cat _av_spin diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py b/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py new file mode 100755 index 0000000000..d543f86cba --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py @@ -0,0 +1,34 @@ +#!/usr/bin/env python3 + +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +import mpmath as mp + +mub=5.78901e-5 # Bohr magneton (eV/T) +kb=8.617333262145e-5 # Boltzman constant (eV/K) +J0=0.05 # per-neighbor exchange interaction (eV) +z=6 # number of NN (bcc) +g=2.0 # Lande factor (adim) +Hz=10.0 # mag. field (T) + +#Definition of the Langevin function +def func(sm,t): + return mp.coth(z*J0*sm/(kb*t))-1.0/(z*J0*sm/(kb*t)) + +npoints=200 +tolerance=1e-5 +ti=0.01 +tf=2000.0 +sz=1.0 +szg=0.5 +for i in range (0,npoints): + temp=ti+i*(tf-ti)/npoints + count=0 + sz=1.0 + szg=0.5 + while (abs(sz-szg)) >= tolerance: + sz=szg + szg=func(sz,temp) + count+=1 + emag=-z*J0*sz*sz + print('%d %lf %lf %lf %lf' % (temp,szg,sz,emag,count)) diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py b/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py new file mode 100755 index 0000000000..8fa6f55589 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py @@ -0,0 +1,34 @@ +#!/usr/bin/env python3 + +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +from scipy.optimize import curve_fit +from decimal import * +import sys, string, os + + +argv = sys.argv +if len(argv) != 3: + print("Syntax: ./plot_precession.py res_lammps.dat res_langevin.dat") + sys.exit() + +lammps_file = sys.argv[1] +langevin_file = sys.argv[2] + +T_lmp,S_lmp,E_lmp = np.loadtxt(lammps_file, skiprows=0, usecols=(0,2,3),unpack=True) +T_lan,S_lan,E_lan = np.loadtxt(langevin_file, skiprows=0, usecols=(0,2,3),unpack=True) + +plt.figure() +plt.subplot(211) +plt.ylabel('') +plt.plot(T_lmp, S_lmp, 'b-', label='LAMMPS') +plt.plot(T_lan, S_lan, 'r--', label='Langevin') + +plt.subplot(212) +plt.ylabel('E (in eV)') +plt.plot(T_lmp, E_lmp, 'b-', label='LAMMPS') +plt.plot(T_lan, E_lan, 'r--', label='Langevin') + +plt.xlabel('T (in K)') +plt.legend() +plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh b/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh new file mode 100755 index 0000000000..d631fdbc79 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh @@ -0,0 +1,28 @@ +#!/bin/bash + +# set initial and final temperature (K) +tempi=0.0 +tempf=2000.0 + +rm res_*.dat + +# run Lammps calculation +N=20 +for (( i=0; i<$N; i++ )) +do + temp="$(echo "$tempi+$i*($tempf-$tempi)/$N" | bc -l)" + sed s/temperature/${temp}/g bench-exchange-spin.template > \ + bench-exchange-spin.in + ../../../../src/lmp_serial \ + -in bench-exchange-spin.in + Hz="$(tail -n 1 _av_spin | awk -F " " '{print $3}')" + sm="$(tail -n 1 _av_spin | awk -F " " '{print $5}')" + en="$(tail -n 1 _av_spin | awk -F " " '{print $6}')" + echo $temp $Hz $sm $en >> res_lammps.dat +done + +# run Langevin function calculation +python3 -m langevin-exchange.py > res_langevin.dat + +# plot comparison +python3 -m plot_exchange.py res_lammps.dat res_langevin.dat diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template b/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template new file mode 100644 index 0000000000..6e79fe9d25 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template @@ -0,0 +1,46 @@ +#LAMMPS in.run + +units metal +atom_style spin +atom_modify map array +boundary p p p + +# read_data singlespin.data + +lattice sc 3.0 +region box block 0.0 1.0 0.0 1.0 0.0 1.0 +create_box 1 box +create_atoms 1 box + +mass 1 1.0 +set type 1 spin 1.0 0.0 0.0 1.0 + +# defines a pair/style for neighbor list, but do not use it +pair_style spin/exchange 4.0 +pair_coeff * * exchange 1.0 0.0 0.0 1.0 + +group bead type 1 + +variable H equal 10.0 +variable Kan equal 0.0 +variable Temperature equal temperature +variable RUN equal 1000000 + +fix 1 all nve/spin lattice no +fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 +fix_modify 2 energy yes +fix 3 all langevin/spin ${Temperature} 0.01 12345 + +compute compute_spin all spin +compute outsp all property/atom spx spy spz sp +compute AVEsz all reduce ave c_outsp[3] + +thermo 50000 +thermo_style custom step time temp vol pe c_compute_spin[5] etotal + +variable magnetic_energy equal c_compute_spin[5] + +fix avespin all ave/time 1 ${RUN} ${RUN} v_Temperature v_H v_Kan c_AVEsz v_magnetic_energy file _av_spin + +timestep 0.1 +run ${RUN} diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py b/examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py new file mode 100755 index 0000000000..7acb780143 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py @@ -0,0 +1,27 @@ +#!/usr/bin/env python3 + +#Program fitting the exchange interaction +#Model curve: Bethe-Slater function +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +import mpmath as mp +# from scipy.optimize import curve_fit +# from decimal import * + +mub=5.78901e-5 # Bohr magneton (eV/T) +kb=8.617333262145e-5 # Boltzman constant (eV/K) +g=2.0 # Lande factor (adim) + +Hz=10.0 # mag. field (T) + +#Definition of the Langevin function +def func(t): + return mp.coth(g*mub*Hz/(kb*t))-1.0/(g*mub*Hz/(kb*t)) + +npoints=200 +ti=0.01 +tf=20.0 +for i in range (0,npoints): + temp=ti+i*(tf-ti)/npoints + print('%lf %lf %lf' % (temp,func(temp),-g*mub*Hz*func(temp))) + diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py b/examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py new file mode 100755 index 0000000000..0141af56a0 --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py @@ -0,0 +1,37 @@ +#!/usr/bin/env python3 + +#Program fitting the exchange interaction +#Model curve: Bethe-Slater function +import numpy as np, pylab, tkinter +import matplotlib.pyplot as plt +from scipy.optimize import curve_fit +from decimal import * +import sys, string, os + + +argv = sys.argv +if len(argv) != 3: + print("Syntax: ./plot_precession.py res_lammps.dat res_langevin.dat") + sys.exit() + +lammps_file = sys.argv[1] +langevin_file = sys.argv[2] + +T_lmp,S_lmp,E_lmp = np.loadtxt(lammps_file, skiprows=0, usecols=(0,2,3),unpack=True) +T_lan,S_lan,E_lan = np.loadtxt(langevin_file, skiprows=0, usecols=(0,1,2),unpack=True) + +plt.figure() +plt.subplot(211) +plt.ylabel('') +plt.plot(T_lmp, S_lmp, 'b-', label='LAMMPS') +plt.plot(T_lan, S_lan, 'r--', label='Langevin') + +plt.subplot(212) +plt.ylabel('E (in eV)') +plt.plot(T_lmp, E_lmp, 'b-', label='LAMMPS') +plt.plot(T_lan, E_lan, 'r--', label='Langevin') + +plt.xlabel('T (in K)') +pylab.xlim([0,20.0]) +plt.legend() +plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh b/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh new file mode 100755 index 0000000000..ecbe7d2eff --- /dev/null +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh @@ -0,0 +1,27 @@ +#!/bin/bash + +tempi=0.0 +tempf=20.0 + +rm res_*.dat + +# compute Lammps +N=20 +for (( i=0; i<$N; i++ )) +do + temp="$(echo "$tempi+$i*($tempf-$tempi)/$N" | bc -l)" + sed s/temperature/${temp}/g bench-prec-spin.template > \ + bench-prec-spin.in + ./../../../../src/lmp_serial \ + -in bench-prec-spin.in + Hz="$(tail -n 1 _av_spin | awk -F " " '{print $3}')" + sz="$(tail -n 1 _av_spin | awk -F " " '{print $5}')" + en="$(tail -n 1 _av_spin | awk -F " " '{print $6}')" + echo $temp $Hz $sz $en >> res_lammps.dat +done + +# compute Langevin +python3 -m langevin.py > res_langevin.dat + +# plot results +python3 -m plot_precession.py res_lammps.dat res_langevin.dat diff --git a/examples/SPIN/bfo/in.spin.bfo b/examples/SPIN/bfo/in.spin.bfo index 2cd9200121..a32dde9dd7 100644 --- a/examples/SPIN/bfo/in.spin.bfo +++ b/examples/SPIN/bfo/in.spin.bfo @@ -51,6 +51,6 @@ thermo_style custom step time v_magnorm pe ke v_emag temp etotal thermo 10 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] run 2000 diff --git a/examples/SPIN/cobalt_fcc/in.spin.cobalt_fcc b/examples/SPIN/cobalt_fcc/in.spin.cobalt_fcc index 9193faa798..dd9ed890ee 100644 --- a/examples/SPIN/cobalt_fcc/in.spin.cobalt_fcc +++ b/examples/SPIN/cobalt_fcc/in.spin.cobalt_fcc @@ -57,7 +57,7 @@ variable tmag equal c_out_mag[6] thermo_style custom step time f_1 v_magx v_magy v_magnorm v_emag temp etotal thermo 50 -#compute outsp all property/atom spx spy spz sp fmx fmy fmz -#dump 100 all custom 1 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +# compute outsp all property/atom spx spy spz sp fmx fmy fmz +# dump 1 all custom 100 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] run 1000 diff --git a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp index 8ea82a509b..e5a49cd336 100644 --- a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp +++ b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp @@ -25,7 +25,6 @@ velocity all create 100 4928459 rot yes dist gaussian #pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -# pair_coeff * * eam/alloy ../examples/SPIN/cobalt_hcp/Co_PurjaPun_2012.eam.alloy Co pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co pair_coeff * * spin/exchange exchange 4.0 -0.3593 1.135028015e-05 1.064568567 #pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 @@ -56,6 +55,6 @@ thermo_style custom step time v_magnorm v_emag temp press etotal thermo 10 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] run 20000 diff --git a/examples/SPIN/iron/in.spin.iron b/examples/SPIN/iron/in.spin.iron index fd504d2cfd..93485ee076 100644 --- a/examples/SPIN/iron/in.spin.iron +++ b/examples/SPIN/iron/in.spin.iron @@ -52,7 +52,6 @@ thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe press etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -# dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -dump 1 all custom 100 dump_iron.lammpstrj type x y z fx fy fz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] run 50000 diff --git a/examples/SPIN/iron/in.spin.iron_cubic b/examples/SPIN/iron/in.spin.iron_cubic index 859d9df0fa..349a6de3a0 100644 --- a/examples/SPIN/iron/in.spin.iron_cubic +++ b/examples/SPIN/iron/in.spin.iron_cubic @@ -52,7 +52,7 @@ thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] run 2000 # min_style spin diff --git a/examples/SPIN/nickel/in.spin.nickel b/examples/SPIN/nickel/in.spin.nickel index caa1c940ae..7096fda960 100644 --- a/examples/SPIN/nickel/in.spin.nickel +++ b/examples/SPIN/nickel/in.spin.nickel @@ -52,7 +52,7 @@ thermo_style custom step time v_magnorm v_emag temp v_tmag etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] run 2000 diff --git a/src/SPIN/fix_langevin_spin.cpp b/src/SPIN/fix_langevin_spin.cpp index e7bbacca6b..6b9ad517bb 100644 --- a/src/SPIN/fix_langevin_spin.cpp +++ b/src/SPIN/fix_langevin_spin.cpp @@ -119,7 +119,8 @@ void FixLangevinSpin::init() double hbar = force->hplanck/MY_2PI; // eV/(rad.THz) double kb = force->boltz; // eV/K // D = (MY_2PI*alpha_t*gil_factor*kb*temp); - D = (1.0/MY_2PI)*(MY_2PI*alpha_t*gil_factor*kb*temp); + + D = (alpha_t*gil_factor*kb*temp); // D = (12.0/MY_2PI)*(MY_2PI*alpha_t*gil_factor*kb*temp); D /= (hbar*dts); sigma = sqrt(2.0*D); diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index 8150a7ab19..d547de6995 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -242,7 +242,8 @@ void PairSpinExchange::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= 0.5*hbar; + // evdwl *= 0.5*hbar; + evdwl *= hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, @@ -351,11 +352,14 @@ void PairSpinExchange::compute_exchange(int i, int j, double rsq, double fmi[3], Jex *= (1.0-J2[itype][jtype]*ra); Jex *= exp(-ra); - printf("Exchange : %g %g \n",Jex,Jex*hbar); + // printf("Exchange : %g %g \n",Jex,Jex*hbar); - fmi[0] += 2.0*Jex*spj[0]; - fmi[1] += 2.0*Jex*spj[1]; - fmi[2] += 2.0*Jex*spj[2]; + // fmi[0] += 2.0*Jex*spj[0]; + // fmi[1] += 2.0*Jex*spj[1]; + // fmi[2] += 2.0*Jex*spj[2]; + fmi[0] += Jex*spj[0]; + fmi[1] += Jex*spj[1]; + fmi[2] += Jex*spj[2]; } /* ---------------------------------------------------------------------- From 60fe0c0b86042e87784cf682f26ef45a040009d0 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 09:24:56 -0500 Subject: [PATCH 398/557] Silence compiler warning --- src/fix_print.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/fix_print.cpp b/src/fix_print.cpp index 67f164e05e..54132a3ce6 100644 --- a/src/fix_print.cpp +++ b/src/fix_print.cpp @@ -149,7 +149,7 @@ void FixPrint::init() /* ---------------------------------------------------------------------- */ -void FixPrint::setup(int vflag) +void FixPrint::setup(int /* vflag */) { end_of_step(); } From 32753a59e6ae5d8c9b1eadf09e8507033464a957 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 09:42:44 -0500 Subject: [PATCH 399/557] one more whitespace cleanup --- src/fix_print.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/fix_print.cpp b/src/fix_print.cpp index 54132a3ce6..54a706d24b 100644 --- a/src/fix_print.cpp +++ b/src/fix_print.cpp @@ -136,7 +136,7 @@ void FixPrint::init() } else { if (update->ntimestep % nevery) next_print = (update->ntimestep/nevery)*nevery + nevery; - else + else next_print = update->ntimestep; } From 9ea5e402553f807fa615af6fe445a3d118945789 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 12:35:50 -0500 Subject: [PATCH 400/557] move developer's guide tex sources back to src/Developer --- doc/{txt => src}/Developer/.gitignore | 0 doc/{txt => src}/Developer/classes.fig | 0 doc/{txt => src}/Developer/classes.pdf | Bin doc/{txt => src}/Developer/developer.tex | 0 4 files changed, 0 insertions(+), 0 deletions(-) rename doc/{txt => src}/Developer/.gitignore (100%) rename doc/{txt => src}/Developer/classes.fig (100%) rename doc/{txt => src}/Developer/classes.pdf (100%) rename doc/{txt => src}/Developer/developer.tex (100%) diff --git a/doc/txt/Developer/.gitignore b/doc/src/Developer/.gitignore similarity index 100% rename from doc/txt/Developer/.gitignore rename to doc/src/Developer/.gitignore diff --git a/doc/txt/Developer/classes.fig b/doc/src/Developer/classes.fig similarity index 100% rename from doc/txt/Developer/classes.fig rename to doc/src/Developer/classes.fig diff --git a/doc/txt/Developer/classes.pdf b/doc/src/Developer/classes.pdf similarity index 100% rename from doc/txt/Developer/classes.pdf rename to doc/src/Developer/classes.pdf diff --git a/doc/txt/Developer/developer.tex b/doc/src/Developer/developer.tex similarity index 100% rename from doc/txt/Developer/developer.tex rename to doc/src/Developer/developer.tex From 0ef3d0e59adc4744627d5f6f8fdacb734b804893 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 12:36:05 -0500 Subject: [PATCH 401/557] update README --- doc/README | 28 +++++++++++++--------------- 1 file changed, 13 insertions(+), 15 deletions(-) diff --git a/doc/README b/doc/README index 6db4ba3ca7..96b17f9bf5 100644 --- a/doc/README +++ b/doc/README @@ -5,7 +5,7 @@ sub-directories and optionally 2 PDF files and an ePUB file: src content files for LAMMPS documentation html HTML version of the LAMMPS manual (see html/Manual.html) -tools tools and settings for building the documentation +utils utilities and settings for building the documentation Manual.pdf large PDF version of entire manual Developer.pdf small PDF with info about how LAMMPS is structured LAMMPS.epub Manual in ePUB format @@ -25,17 +25,12 @@ the fetched documentation will include those changes (but your source code will not, unless you update your local repository). (b) You can build the HTML and PDF files yourself, by typing "make -html" followed by "make pdf". Note that the PDF make requires the -HTML files already exist. This requires various tools including -Sphinx, which the build process will attempt to download and install -on your system, if not already available. See more details below. - -(c) You can genererate an older, simpler, less-fancy style of HTML -documentation by typing "make old". This will create an "old" -directory. This can be useful if (b) does not work on your box for -some reason, or you want to quickly view the HTML version of a doc -page you have created or edited yourself within the src directory. -E.g. if you are planning to submit a new feature to LAMMPS. +html" or by "make pdf", respectively. This requires various tools +including the Python documentation processing tool Sphinx, which the +build process will attempt to download and install on your system into +a python virtual environment, if not already available. The PDF file +will require a working LaTeX installation with several add-on packages +in addition to the Python/Sphinx setup. See more details below. ---------------- @@ -47,10 +42,9 @@ Options: make html # generate HTML in html dir using Sphinx make pdf # generate 2 PDF files (Manual.pdf,Developer.pdf) # in this dir via htmldoc and pdflatex -make old # generate old-style HTML pages in old dir via txt2html make fetch # fetch HTML doc pages and 2 PDF files from web site # as a tarball and unpack into html dir and 2 PDFs -make epub # generate LAMMPS.epub in ePUB format using Sphinx +make epub # generate LAMMPS.epub in ePUB format using Sphinx make clean # remove intermediate RST files created by HTML build make clean-all # remove entire build folder and any cached data @@ -103,7 +97,11 @@ Installing prerequisites for epub build ## ePUB Same as for HTML. This uses the same tools and configuration -files as the HTML tree. +files as the HTML tree. The ePUB format conversion currently +does not support processing mathematical expressions via MathJAX, +so there will be limitations on some pages. For the time being +until this is resolved, building and using the PDF format file +is recommended instead. For converting the generated ePUB file to a mobi format file (for e-book readers like Kindle, that cannot read ePUB), you From 125b29a686e2688533dd41eb33f2b886451df10e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 13:50:30 -0500 Subject: [PATCH 402/557] replace non-ascii character --- doc/src/Install_conda.rst | 9 ++------- 1 file changed, 2 insertions(+), 7 deletions(-) diff --git a/doc/src/Install_conda.rst b/doc/src/Install_conda.rst index 04b8054353..33188e2540 100644 --- a/doc/src/Install_conda.rst +++ b/doc/src/Install_conda.rst @@ -32,12 +32,10 @@ install the `openkim-models` package If you have problems with the installation you can post issues to `this link `_. - -.. _conda_forge_lammps: https://github.com/conda-forge/lammps-feedstock/issues - -Thanks to Jan Janssen (Max-Planck-Institut für Eisenforschung) for setting +Thanks to Jan Janssen (Max-Planck-Institut fuer Eisenforschung) for setting up the Conda capability. +.. _conda_forge_lammps: https://github.com/conda-forge/lammps-feedstock/issues .. _openkim: https://openkim.org @@ -45,9 +43,6 @@ up the Conda capability. .. _mini_conda_install: https://docs.conda.io/en/latest/miniconda.html - - - .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Commands_all.html From 9c1d5e76cc59597f796c74c22b3ee951f1d9f11a Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:15:46 -0500 Subject: [PATCH 403/557] Update docs: angle_charmm --- doc/src/Eqs/angle_charmm.jpg | Bin 3932 -> 0 bytes doc/src/Eqs/angle_charmm.tex | 9 ---- doc/src/angle_charmm.rst | 52 ++++++++++---------- doc/txt/angle_charmm.txt | 89 ----------------------------------- 4 files changed, 25 insertions(+), 125 deletions(-) delete mode 100644 doc/src/Eqs/angle_charmm.jpg delete mode 100644 doc/src/Eqs/angle_charmm.tex delete mode 100644 doc/txt/angle_charmm.txt diff --git a/doc/src/Eqs/angle_charmm.jpg b/doc/src/Eqs/angle_charmm.jpg deleted file mode 100644 index c6e6c297d2020d7c1abc75185316e7d706fe5976..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3932 zcmbuC_g4}Q_s1bj^rMO9$B9a=%v^~%a956o*?39|a3sz!cZvzla+HE2EKM`BZKWxR z=3d}HP0g*SL6`$^lq=M)pXYnN&mZu8UiX~)%YC2s{pFr}?%f^UodSrTwL4=600M!4 z(|ZBf9Rr*K><0-52!QtQrTzQ&3xY+3zhBLD*SfduwT2!anPOX{DvB=olmJXlIv_2i8>naj=|p_va0U-W<5 z9R&#eV`v4~&QAXS@}Qfsm#K2xu|9IUQwIJ-ZUUue%Sn$B97S6Jqp9Tq z^gO6XvV&{r%8AyCbW(V=8@UpwYL7?-!t6q1w3 z$ik2bhZh6WPxF1O+YkBr-O$zz&u8=6p~#0e=-hxaU5kWg{!0$7fwBx+ha(**@^I6p zaui3KD8{?E@0@*j+Zt?$R-Ws^9uZ?WgK9}78TUJ*{{(QIFSyp+;X5dQ^n<6LH~^*- z7r#z9EDXBvFWf~jX8d=)X5aHUqgC8E3x(`B>EEL}2J84jEl;o1=?{9d@NgRT5&Oyf zDG-m%(H+0~i#b!KzYGO%VHzm2&=iwu^P!CX#$`*l%n1{ObU?oJjeIDi2-#n)q8nYk z9Xw92?(yY2aF@rwl&NT=^Agu$3fLx3#X4sPni`=iBSNEei}DV$=O1LF&=YIX#+3=r zH~=FqDVh`#r9gj;8{hr}V|w9#bHZ+Mv6BKTCuicypRwe^D{g;|YV$+Yr{szfHjlUf zENi%H{%I>r&Mv?}c!|T0ClHf+ShrZF3H@z4KcI#}j4r}(QJDt;WvC5O6-_%7+g^C6 z019H=q>?U2yA`j7Mif+iGcib|HS7YKb$+&RGf}#Jy`tC$@?D$#OdhbAAnY8X&}uFv z^pW}7LR0tZD<*AWD_esovoWML8zQpGX?8!WBa zMuA(((@k~@wQPz%Zijih=F1w+1D5!G@NH*@sDn;6PNcYz9dIT#Vj4@~9zV#Mu}-Xf z5MYQhbe2-M&VPx{-(Ea3f5ouK5**vKp0Ubry{@ADGLQV8elaHEXOG(7L0@e{HPixn zv;BmBY4OI73!2)Kpn}RjJ_eam{u%V^jz#Pb!8KS!*uNa+u9Z(b{4h~rnWOqG9g;+| zN``bIIR!zskB+=fE*G=XA(v~5Pjf|<+7%X4BenulBf@vWGqjQd^E1t1UQcFeM>`{_ zdOsqbtZS~)o;;^j?gFIcztT3o=U(EMosL?wl&2lfr^MCTpnbRjv+x=ixB+{XbAf@_ zZ;tAWF*pSI?UnV*H#Kles^m2tp&lKPQWcfanbCN;$g8RPU9-^rUi~uT_y%F6tk?2u zP$a`}uFAm$Pu9sDe5`)21zSs88QQt)OUf626WQ&mjUKQWp9IsMXt|6s5-^87ghu@E zX-h^H)W!0cTFNe9kSMnc(23cezuH(<`a_xWGcpmDxfS56M^A1@a^Hx+Ot9x?Ts!UR z&3|<&wry4f7T1&<$d(NpyN(FH#((H`KVURi)+5Y4O+TMqS>0}F&9zDigOw*8-kzB~ zd=w=$;;c#3qj_Ns3twpkDYXMZ!l5p^Ipd2}E#?cR*X6%j7R88EzQ2)8 zV2hvY7eie}s9|B|gTY=I`@&qOI*H*)Ra}9MCE=yd#j8H&;0j6LHA2tt>*MjY8s0u_ zA;Q@9w1c&MruIgM!4V|Jpv_mq!cys(=dFB5?6PZ~0-+{JH9_Q$<92v$+Oa!jRXx1W zaq}EERXb`KJ@8b=Pre(1#D08qBoD)!>t6>bF^4`a1Y?G$mpHW_{a{Yy_^C>?k8;9W zJVwuDP(R>D$funqrPtG2--#7?8|QX`@L&M!mSd}W3{ZUed~tR+h`g1+@x}6SF0b~ zQKYRnt}TcN$-E**g?W<)XAL>a5Z2S~JO+O7NbcNrdRqYpG@ zD{!M@$AS6CqM2V#y_u*m{FKjMpf*mDausMNz8MAK zEA+`B1{lSx5*?Hv&PCEwqS7S$*r&#B`K1#uv!&uMb}p9KH^$y0xvp2WJqr?TohbgG zt#AtLTfw_$nF^n~YX?|GhIdStrgc2aZ3aZ+97vtLHYw?T#UUS7~S&>`O#J?0Yte&RzuIKzbZ<~5! zMDgwg4~@VEOQ4c{{=#4Nle+dhS*uoC?=S2ELi*hoN7`5_)IdlS#GteK9U8BjZE;YL z0YBYiI^0i+H!dozqPluA2BXEy9g(dH*>1)}8V2TS4?=Bp=Q3UvkpCpY`xJz@0x|mF zOG?6gAJts;vNvxu?w9NV=-|XUZbBxiKtBSTr!a-jR}_pDj0MqCL(Q{&Uh0RwExmZ@ z56#5W{k8gxSx|NaaXq(6`TIpW!pGg`NewOR{{6Ehz=|A;rw$m~CqPNgKu<_?)T`f+(m7DT>ck7m5+Bk_*G zhbBXxPx>;2dUe7)VFI|N=#y8w3E1HN-$+I5uZVF$tQ-rxaJqtY#(oCy*@hqJ?)YJ8P=4(yZDI+)*{h zkzd5dkC9{`C0Rul_?^viw9jMh!&Js%-j zvg&2pl1p&`c_%K&JZM0*!6y}4P)2VttpQDFb@<7V0;Ww`ayrrsRYsF6GaszGhU1Nb z^&WL0OYEW9tlO%^HyO`O8048J-$+$0VpAiJxdh=Y#j`&Nk;g3bve#T_d6I1S_4C~# z7Drb`bG;D_J8sjJCOqUM*{4rl8XNpT4mD8V#Eek&(NTj0V!!+M96oGs@Uw6^tEB zOe0)D5=sCD7U#KxNf|!Wdt0&Jg(yYbzON;b@+p;6ichke?~>+ti<3gB%FVSDsx^H z(y3r`9z4^h<}dCD%4Fj>fhAJUJ7%<;ifG3&Yb>f%QO??(!<_ZcTy+MqIu5!#m-grF zw#MD_-;~_4X->IxSPmIeNUoYxTT=t>l&j>PuRGgiaj#mvuyy+`b#yY-dI55!%F@(n z&53SU`JC9(6&7PJc}d2@T=wimrJOCLS|FoepyowGU_hQa8s-S0gigTa7( zssqDFlcb&xxRHJp6~>CL8e<6You7^E_Qc2V0*S9*e>z@nH$0{s&JQ>K2Jq$8k7K(c zTnpPre$MROSpJCv?;sz~$)h>8%A({ch+2iQ#i$Y<=URTP$+Pqd?zL>S zSXQn;dj!jN)QFqvtG5bxb@>@V@($|Pvln!r>I`;#gLS}tJYZ>Qi8-+;5;IU7eq$=~ zs0k?JQsxRQP6TOgaVUwd}}?ypq- zmoyT+pI#AuIj$5QnQu1S7e%m-42@k2=pMiQp|Y|-ElXWOLc*?{HOnskYiRF(0au)Y zrf`G(1pM)7v0-@Ju+7O~JOUaw8n9Oi>{LQ}rSeDnQvr&VWi!!~ZR_ qdjxYtKSap6W4YFJdr_j=){W6cu2Mt(fdaz+IsM!2zf3W^BmV<@w}kTm diff --git a/doc/src/Eqs/angle_charmm.tex b/doc/src/Eqs/angle_charmm.tex deleted file mode 100644 index 00b37ba335..0000000000 --- a/doc/src/Eqs/angle_charmm.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K (\theta - \theta_0)^2 + K_{UB} (r - r_{UB})^2 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/angle_charmm.rst b/doc/src/angle_charmm.rst index 561e6cfab3..92ab8b5ea3 100644 --- a/doc/src/angle_charmm.rst +++ b/doc/src/angle_charmm.rst @@ -1,22 +1,22 @@ -.. index:: angle\_style charmm +.. index:: angle_style charmm -angle\_style charmm command -=========================== +angle_style charmm command +========================== -angle\_style charmm/intel command -================================= +angle_style charmm/intel command +================================ -angle\_style charmm/kk command +angle_style charmm/kk command +============================= + +angle_style charmm/omp command ============================== -angle\_style charmm/omp command -=============================== - Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style charmm @@ -24,7 +24,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style charmm angle_coeff 1 300.0 107.0 50.0 3.0 @@ -34,12 +34,15 @@ Description The *charmm* angle style uses the potential -.. image:: Eqs/angle_charmm.jpg - :align: center +.. math:: -with an additional Urey\_Bradley term based on the distance *r* between -the 1st and 3rd atoms in the angle. K, theta0, Kub, and Rub are -coefficients defined for each angle type. + E = K (\theta - \theta_0)^2 + K_{ub} (r - r_{ub})^2 + + +with an additional Urey\_Bradley term based on the distance :math:`r` between +the 1st and 3rd atoms in the angle. :math:`K`, :math:`\theta_0`, +:math:`K_{ub}`, and :math:`R_{ub}` are coefficients defined for each angle +type. See :ref:`(MacKerell) ` for a description of the CHARMM force field. @@ -49,13 +52,13 @@ The following coefficients must be defined for each angle type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/radian\^2) -* theta0 (degrees) -* K\_ub (energy/distance\^2) -* r\_ub (distance) +* :math:`K` (energy/radian\^2) +* :math:`\theta_0` (degrees) +* :math:`K_{ub}` (energy/distance\^2) +* :math:`r_{ub}` (distance) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian\^2. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K` are in energy/radian\^2. ---------- @@ -108,8 +111,3 @@ Related commands **(MacKerell)** MacKerell, Bashford, Bellott, Dunbrack, Evanseck, Field, Fischer, Gao, Guo, Ha, et al, J Phys Chem, 102, 3586 (1998). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_charmm.txt b/doc/txt/angle_charmm.txt deleted file mode 100644 index 8b0e298a43..0000000000 --- a/doc/txt/angle_charmm.txt +++ /dev/null @@ -1,89 +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 - -angle_style charmm command :h3 -angle_style charmm/intel command :h3 -angle_style charmm/kk command :h3 -angle_style charmm/omp command :h3 - -[Syntax:] - -angle_style charmm :pre - -[Examples:] - -angle_style charmm -angle_coeff 1 300.0 107.0 50.0 3.0 :pre - -[Description:] - -The {charmm} angle style uses the potential - -:c,image(Eqs/angle_charmm.jpg) - -with an additional Urey_Bradley term based on the distance {r} between -the 1st and 3rd atoms in the angle. K, theta0, Kub, and Rub are -coefficients defined for each angle type. - -See "(MacKerell)"_#angle-MacKerell for a description of the CHARMM force -field. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/radian^2) -theta0 (degrees) -K_ub (energy/distance^2) -r_ub (distance) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian^2. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none - -:line - -:link(angle-MacKerell) -[(MacKerell)] MacKerell, Bashford, Bellott, Dunbrack, Evanseck, Field, -Fischer, Gao, Guo, Ha, et al, J Phys Chem, 102, 3586 (1998). From 28402ad656fcd4a3ef18b9f508462dc3199811ae Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:35:55 -0500 Subject: [PATCH 404/557] Update docs: angle_class2 --- doc/src/Eqs/angle_class2.jpg | Bin 16202 -> 0 bytes doc/src/Eqs/angle_class2.tex | 12 --- doc/src/angle_class2.rst | 102 +++++++++++++------------- doc/txt/angle_class2.txt | 138 ----------------------------------- 4 files changed, 52 insertions(+), 200 deletions(-) delete mode 100644 doc/src/Eqs/angle_class2.jpg delete mode 100644 doc/src/Eqs/angle_class2.tex delete mode 100644 doc/txt/angle_class2.txt diff --git a/doc/src/Eqs/angle_class2.jpg b/doc/src/Eqs/angle_class2.jpg deleted file mode 100644 index f0f2a5152ed00db4ecdfe1c21dab476e69235dc0..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 16202 zcmcJ$XHZk^_xBqRL_k^qQ943|&{V3@tB}w`?;=H7Ksrd3UL-(BKm?>E^j;D=D!obX zP3av0>8OYMex7sYoZpN8`Mr7eo>?<{_MTbmx~@HIeXq}6`|tGM?*MA(3&;xq0RaI( z_2vZpodYNWh;I=Q5#1ubF~r2gw@L2aA-OrI$jM3X(og|`G*mP+wD*`9Xz3W~X=v_q z+-GEAVPj*XWq8Q-kd=#>m5uf9X8`#fKncmDAq3;3N1g`u$E|6_))eaF=K8E#g$ z9|}=(V5iUY27GD{Hrc3;f^Dq9T%Bj1#HDAsn`PAXo2}srg#1)^k$hlTzecGD^-g@;gAHz zQ!hz(#ZSupqrC)!^dFrL=G|#%I0N;o z3VKH+k*t^^k4x*@d)BF8Xt8QP!hmR&wx2TM_VGvk|AYY6jU4m{W zuLNsI7PJ?dZFZUP@UiY~0w!RCMnmyp3G&|jhb`A1$c?CFmI{a2E5M5#$F+}(0zTyG z{wd_%j?#S|+O6P*rwfYYZ?<^ffC55;ve^#ly|8>t6_sP}aXW)JeCiiWksJekM@g(o z(K4EaN=^%FgVh!cR7qke3IoK)nB~t;xa#+kyQq8OfA)H`A5u=$?gfT$deylPy54Jw z$d~RXZW3i(dtPWsH~(QjC!*dH{S4SDFRM*;9@{wjKdd>gEU4*4Cnyo2IiMQZ9;4^agMJPg$$dKTgII>2Xb?eeZl zWJxs^@#xik3byn{Q{L<!mk?xDw4n@4A_sYxwdS%A1&vl|$&5?|#irr`C2+}qgZS)pCcL(wPj2hzwNV7bDl z_xv^M<&LFbxt_c(^^^n>SKd2#Jz-PjnDl1f$HE9DK~0)#;RnoFav*MhH@Qov9dj-6 z#J#KA-TO1N@@Zq*aUb3rR`*Sk_u6|i$2l0X30{lq-e0(!N;1~*t?4oQpyoC?THQAX z(s-6X`K*-K+k{T4X~+6y>{Yxa+z*u5)bddQqv+Ocq894_|D;j>??V&*G7sLhFS}+pLUxm1w>4-!UUZYXDQ0x zDxegaD4|gAKs}PelEFN|jssfV+at*{f{GE{Rv=w-lCND+N zTBEe4?$G0Bs|u?>*xH{a_5LD+`QYiO@>}c1e>PAqRXPXlC5b%96ur|B-RaL?_Odx8 z%Bly4b~`#~_Y(eZh62<39}<{Z{~nubf3?g<^QyZF?YuVqH9WTN9g$47DRE()ko9Ff zJ#9Jw>C}MarCx{s;QGYNR|~JVQsgl0h{#vfyZ!$5%i-Zzkb*)q_zKo z^=ov#ahutK&_;EC#+;QBQ4XqPoTD~}i3J722Avp#b$sUNnEF2Ib??XDdq;XMiTRMe zi0}X6Ce_^HQ+|0Y%5+I(`xmg{?s_2F{TFZmOOfQ46k<^qFV~Dxc;0189?GKSpL_MWT~Q#UdPYnJjwL_Czh^dg zP}E{8Os=gy?7H203ARp65)~ioUmIOPt>GH*j|${!zq!zn7>sIP6{}G^XD>k@v(c^L zaIh-l$jrXWiPrWlm&g2D%Zan7lp}Fe_3f`J3x)(WyJB+JJtYzLmKz%QIrPINyHww# zmPaB!CUB+AGhQzTRn1>i?*12yYv#oGHD5L@##+lKrt>B9X~@^}tIB8s4T-C7MamFf zB-M}alJC}F$rXMA)l(^6RQy#Bds#c30>yl9L)qL^?;J9FeVqZ%jzuP03K z7WlntJlB;v z%?P?!(%k02aWJTZn%6ky$gR?#TLM+^$@WiP>Y3u*6lml7eCa!p zdl9<0X0bYuEVJ>DzmUvfYS9bI3(-pqrXrZ9;zecp_rg<}YYP2rWA3S*@|kYcd=}Ea zij`A|UMauVt2v1g3rP&p4qI9;-uw7l5+f#QA?umAH!EF1j`nR7VT6)DevKy#U%6 z?`^$bMHh8zMc3^?R|e&H5|OzmG)=h@VcDk>Q78-@xKxILM?;NMpaiD z=)mx<*~&B*dQX+4gS8wD0H!%(n9&B$M3frJ03oR{@qW8CpQ_<2rIUak~W|88R< z=2-*zf^OXOsh-A1{lP*V7@~@ProX#RoM^bd*3W<*ifkUZN$KH`+jMBIL`)GmgjHoY#PQ2N^TEgTxbkR0 zQA=z&&5}exk5r+SzSE)`3K{vuxmf*=Of^~xj3gvK5F0l6N;4?uu5+ZilqNHQEID5^ zc4=E>*pVWV(zo%;=aRr|k(-S4tDfEJ54xIaG5TkWSY9@B`USu0@>Lms@9)3)}rKJ`4TZ!`CN89}InqDPr`*ff`!CY?N zSJR#&`->M!C*LIB3;%e5Q*LM;MmBfbxrua0T+n9nBQ(}8IqXj z@2+MISvn99rMLGMP1plYa=eyHAl;SLT@ylTiR%bZ;I?u8r4bTjLjz?L$vNd%sJ?%Z zu^B%bQM0YbaKQuo3&GpT>pS7$xarFxTQJ+6p-{h$M@K1(Y_mBg%7Ywd2#oDVr_a;=goePJ?+4w~27C=4)l0h|hqt7yjptCg!a3bR^4? zgX7n;o#9;(4_B|nT!hKr%jqR5=uXoYK~;I7B)u&@+|kDm>)vve1`fC^|B;p6DNOS8 zyO>g86u1t+V#(dc3lvqE!(LK;7B9b?X&I+uS~-$<=hHRbZxt<8D4e*-jYM`rjP?g+%LZFK67!7%BgYPjxJo0ynqYPcwwI*R zm!em+nr?6K^N(H3;g#$HYVl+T)$>P@XLy??u;3Vp#AXSB zWU+{l;eG$C4ZX!&nG)<@0PC0GGGQOx(S13;;=6AU@IRW*cJ3H9(pBwPzU@T!wEygA za)1{+HUvA*mJXB##HL)s!HY z3x0{4&Iw8pbOmzTjcZ_&)b#g~(x2e7%RgVy@$5qqw~iF;Au#lH$fJ6(*WL|OHRzR+ zRQG(>qdB`Zd$MC(ZNbRTQv9wSn!Un&(jePAli(7VQ)4Q0P`~@Z?GsHww(l^=so4R% zKNof+V?68iT`jW(wetvf#kTR#%l$pP@w7!n@^Rv)t>C@aSAvp5Soi_ zUN9t{;K{_HzM?siLCtv>pIFM?~}`!5tn;y|NH5k2b-&b8a)dRU?Hf{*q{Z>{ZN#A@cn z#PS(D%D1)`r{&ZU&p}KM*i5kHy5wP@R(T`GSzqkJ>Dl}Ew~RZJOSk^z((^fu&NCKW zsW?iMz&HwPq8lGxCS8mCF7xq;Ip-((iT9^KT04jGHwug~vYpFJvEdG+-#CH-_+d7)+l16y zRN%$-Krm$$698O1*4ApfM#x*v| zrDHrZ^1`7_B}h5fUziDTnb-FD%wc>d*@>jlATu7b88#i__yTS4&FU#=v&4s?)uIO) zB6cxY$+#~|ZMx^2m4DqLsqeb~A$YrA_|I&@UqE?@0R??wX`hCt$CmYjE?I*9B($S&o;>`ez|<{U zi`zpl%U|XNo!mcFOPm!R&}{dh$*)3+@|5u)jNg*KuVvxda)PEGd_J3oB^~pyF1m5F zmp|Ax`<=Tt8Aa13OAbSd{#s9!^gmcEnYk^|1v$-2IBRl|B%F%!O@c+G%uuxmKukgt z<#!`LOaBGD&7|zkZOd8@l#d>Z!3}yfX`t$l7Wm?rtfpXCB$U~=v|vn?$XilclGE<` znkbK@!4!UUEvL78PM$LJ0`Xaa)jq7nXKmA;W!JEEZ#(N(|J^^^kiUQ@MHzNthAdit zkc*{w_UtTx>7HQwkB$D+=Tz=Xa3@4|E>Zh^r(d7>JofGQ zcZA&Hyf#6#OmnPfpwv$GXs&D0k;*6M8Nta98bp7pgayiP(qh{a*wtG$4YqHEVugNf zm$tpYj3^f1ZE1VKXU?v4U^W`}Wx}AxFGCq>dJe2BM|d~A#a!RxHe1c$V+N`}2cGf0 z2TIG6c@1W*^X;p7$6Iv^`piV>l#Q^YoCOBNXO~%ir+CAf=9%@YVi#ABPhIdnNmhQl z-;dyn<%9+XNory!zwe4b5ff$cAztQM*?!3lLuzpGv>c5E6Zt4l2WzN{DR)?Qf`aN= zg)Q00fP2Q*-hw37*`frCnF!Y!E?>mAXuNiW^Z=i|w!GU{)#bz)l0_UAA#0!hD&xol z_~HIiqixrr=-zqyQk$z|*bW8y0h@87xno8|gQJ5FWGIIZ_FQ6&0$Y*BMJ?|IJ^npA z(OzXQ&Q=TR=fVqZ)-0c{I3Vy`&whIQV+0iv4e}}|+9+x&7GY5zRaxwQEsV@r56SO z_jadyPvy6)>73S-iRUGm!@Snt#0DF|B(X?rqLhl12sb`A`kE^)sn2yP?$j38v3h^N znixlWc$Yy&5MuSXkSBr=MO1c!4O=o3MGf9R{0m^>Yj>Uzc`-i5V8lP5=qM==MNQw4 z<<`R1S0elRd+l1=y@m@|{ww;X?PXYi&8e zOV^GntDb?poO@tr{nMFnBQuB|Il`KtVT&jP2TU~wbNMjoI&Eaz53lDEem-Q8X(U~2pg1kgFJ71sR6$rrzH9xwT&?vNkXTw- z_8Y3y#UL)w@hLVHXaUc#Q*<&BKPD>urVZhI3*w#nlz=vMI;NzziF3T-s|qlC4y(R8 zPx?8C7hNC!-DSFeyPK|*0#iuueJxO!oUP%B$f^;4km|Ta5vpXg+3i+;^jg!*{UG)@ z&IAbj1R3UqPm~ND0z@|qS<_ZG1UihHB>J79N-@-HVlyDHUsOt8pU+Z^uB~F=uNT`) z81~=CG%54G|@$yr>T+}{AtJOdbA)~G>p4@qoB~J zRgrAIXtH0R)!93{+Z3K+Bl#VRmorvfW>PHN^?n{tNLIT!k;h&={Ya(fWeuZE%u#+1 zjD?aR>#f>10SNm}`yE}#i?8~aOpJHQ;7wR)lffruuZ5sANTt;0s5ju3W?UjeTs%d* zKZk3x3u$LemQsVhVwS2t2eX;StZBLf=YCG=OCKF2wK!sA?|v>Q*TIfT~#sgvF_VBEO+jC97`y~Oft8uo_29?7!O5BlW9fzu09dV8WOcka_mncufI&nJa z_|E=){pqO`SN(FP7t|yLZxAq9SBMrc51HZGBv>VOk1-OIThgqd%&2m8n?CDDO(-{z znB1*lw8nO#L)&Q6gE+(Fxs#y&A(~|u8B}f9*(cL6vbR{({ic*RQ8|(Km>n|z0%#F9 z#L{Ql+0ejW7p_>iFKgj_QI+-G}KOKj}ps-JwCx&!~@M*;DBvN-?FI0heoAttYS{{)TeJ zsG(}X>6sq0dbXyD_r3zc#5vsQf}v)DM~WuXq!;MgKR|thplnl2?uvE)-fsPMI_)># z-5U(wMzI>+8vbs+&<#F(yDv_j9j=h?Vo)Nc!b*hyk{GFf_yp61#GyhlbVrKug?!57 zoK+*Y@d5_t22K9j0*524!knsbR>jvgSuh9}(jN(t9&{c>m-yo4n`W^l`#MRF=x{f{ zrlQwgdxSo8&=xmq$kC(TumS-;Za&`en|c<{1@0z8$sOdhP-Oaj%)?u?t<2o>{aro0 zHz@Z}^;)blS6+Kl)m$ay+!`3PWX*TDTk8fBUzK*i}s0&uvMVwZ_}0maoY4 z@=-`kqUNY(g3CgLX<3vAI37Zub)2{t3~n314oLHydG={|Ds z6UZkjJaZ^;Urk4)-c8OWiKY8NX-``&w=<@1w)2R^zwy@c=CCSSSg;(2fTG%!ZgbDB9$Y&C=Cdl&3L6i$L!E~`;P)_S-XrI z?=rCsh)8?2C+d$cDx#2>NoDw$SdW~A86FjJ@z525AV!=>s2(LsT)?hQuJ(nQzdtL` z%uTZqE1+gtBI9H-4oxZl?2PmT91-Fjpn9MRx=Pd6`JT^+DRa6r?ZF%O=J>pnHNm*? z+?2jpbakRE4Xe^bkU4Ve_4fQg7X?mvl>S@az=ONpZkYP90g2_|ipeqn7UHE?H4SEI z+I?c`e(68*w&` z$I=qtSNxZY9@iI`ue2?Y8AF4MlMHzOSK9tJcmKBrt(q`?{ZkH}64QGC zpXR80lk!EsS%OAT&WMdHY+52`JH)H!&!$xKyYV`ul_}f-Lerax?EKD9u`n#QN!5)A zyU2MC%;`?KD&pPCCc_r}gW$kAVtjKx;8b$|f%|xJ{~RD^k(K2`oT(T0#Lc$!DuU|_ z^1q$_=W4Wx|4J3PH}0idTGAY{k>vATD{EmrP1Su=6dEb}C(6i}x2j+vPz=hVC zfVPVFC3?2f?A14ruiwm!gVW~Su|37)xa3K>onV&+qr!ZhYGm4=)B}t0zQlXFo#M7-i&xKdSd4;iLDq{1hF#S$B9%pJ#InHr|wVQ940gj_98VxRu z{epx(l)y#OsRq?uN6BA(;(r0`y=~R3e*q^joMe-a-Gb>G7oA%+gpZVUL8hl<$3=_= zE#GYXy&5&Xnw+b|_APo@^r&)WU68G?NQVCo+XL3aMt=0ReBagjARBAyKDF}JzpZV< zQf7>*C8(XoE_Mt0I5m3uq`tsXxI(f^Z3$_jHW)TH*gjA9anszOu_4AYmA%14n=y#E zX#5M*pGdMjPVtBgTsB?xvHfQWJa>%#@io)a?@IQ_L~KAArZ7bH)*;VkCNT?RvGLou zBulq73x3~M`xME!-)yZnnP)J)=PgfM+^BP8fNS%_{XQBg z`Q;RaP_>MJ^CNcGe!JFmbiD;})=J**W$UzukE5k5iTDy?x`z@T-oD10dSV?d9_7zD zprtjQ{X~prP>9LAzQaVSHU6o6+bOGVoIl0d&(rh;dt7G!{eUOiMyZ!YF87#xzSheCqVN3bfTc}uM{gu4p!dO?j(g5e_jD(EauAkQO~BBJktXv zVZV$uz^Unm$l+{-cbC+vD0hbwtjm?Aw{>^~J_s z;2@K+gz~&c7j>JYskMuH46oT-=G^1J)2k$N@XrR5*A3i*l9OHC!O$XGs90i!&BELYV2%Xa?56c^~bjyXTmADL5b+tQlXX8}O zy<>V1#cY{DAyAD}K7sf9PLd)!7XXIx)uh-{OqxZE8J1H15PanJ_ABr*f37s8>Fr!V zb;>n~+2OmFZUDN-SqC|mLJvuu>5>Ir!7HasH{BPkDxNiwUsgHr4=f&?lv@aE`ZwJ9YDP!_kVAa+g7v4e8j4#`48NP5nu`W!i*S}sb%Kj%KRYU5p#hck|>8EV$g*_t=XqQ8VL#qrNBx=RLkEz=H?{&7@g`-T-f+n^uoO_Pok z#xqc0J-%0eC67xC0IoPdRlMlE0aViC!OB%rZZarq15z-|whNE5jqtlx=oZJH9MUz8 ze65)BPtdN83z(r{jdO94q`;D@@}y+1lvhXC(_`;8FxVWd!xCQlzOOf5K6_kf%<}R3 z70?JLA6j6L5*h$@^(}EjQ4()cUrK;=kz|Y`2!Qc2mV%QkvOe(UE*}=6rHyq4e&rvx&ax_^oWsnYk zE~_!G=0I*?l87Z(Fu`k14jq?=Y!8n)dQD*O$lZtmPasJe_iQ~zjejm-=HdE)ok3A5 zpXXJFogR`5b+tbLC-RFwR-MWUmNnV+_B$-cMf<2aQNH-_l}o7Vs>ehD8N8~j6Ex)A zgksGq-|`Q8NWAzL;F0E=&Z=ljDS}_rQJ_nnr=E7Uzi`sWPmp&WeQSc2RXoXxZ~FX> zRbq}DNM4b^+)!1CdV(&JQk6nNrWr-9Hy)ZwzqOhm7Iv*R`4G|+n|{a`!Mg?mYmQ2y zi}-6%$Y5e|;S!zZ^OGUi`)rAoB8zP=eq zvG#D6dhx{%H5UYA&2q6*7>!Tv06TC|AiYjR8UDmv8viMKGPKLH^h^I^_v_l}viO^^ z){E6s+yL-)M2g9aUT#%YfHP9dRmd@Eg513C_c&$d>|7YfoRV7lSR$W&T%sxcDJm}m@B6U455dKpUcsOt(bSB#J*^$DtI zNiV%-RCZ>5@#q4LYCI$$ZR2)NG7z{mS$!OVr zL=NRo@Hj2SoQekgN2>bYmnMcyH||~BmptC5(WGEXF@+c`L>oqjCM45CgLuh^sO8v0 z`4oStv0i=B$IQVBN0)$>yl%ErtYlE+mglFShfr!*t6B0F3C`%rJ>(F)M(EgJ`b*+f zU*HM4$VKYMFyB9lw+tW#+5JcHZv88JpkeL12z_Gv=5)BKDg^Jy zh9qz$W(K6|tr>7zFL{&)ZqVT5ueP00jeh~1t=}E2pw2Qd0uFK*6RR8{CNJegGt0V$ zA8x^IZecZ7w!gmi)%Yb^Y;iPl&Vg5(Se`;;)?03dXwy~y_05RGdY-C*E=Y3oxKLdLfc8r&L+gf<@vy2Y zZ$@g2_2{3I$8#{OIi`x&u|1B=ZC%moW-DAv=c|E2?I=sKoI0A^HDGUd@< zg>xZp6teGMq^7f1$8$;a?)m>()c@3||LXYv*5p-3eMmsegP@rY@A@829#`K7Q;LOC zLfH#xR;jS=pCZJQYyvr|*8GCt!FFELsS4UVJPOn+o&4-UB@JMKvlHHuE-I%slWMb= zxD-W?<~cp<@}i&!&mWm#8n^r{Hl6pDdaEA6{tfaFahXs*j}nr>LU8V~Ue@sHl})0pi*E>f zGS(u8R&u~8uNTQ6V4}OjwUfd(=8(*f$hEZ@U*UK@RwjYW&rl2jB4OE{Dj%+Q7Qj%$ zESfet(Pi!q@G4E~<)P6z8hh+KCaN@pybe~N0pHgfq9vT*cA14 zA3EW7b5Fwh+?+HTaCURdZpu(S?$}Xk$iAA3*s^%b;m@=A-RuAVASe0%0yr~-N+?NQ z1_*mK`yy>s0buQH(F&Sjs)Hh^qCFQ)9qkgL#1haf^EM~r$Fg1wb?M+7M&&$e{5bvr z#WMqh6G#c3om1^KaA{BZ4ytci{M_+LvzW%((~gE>(;Gf=Vc(as9s0mN$WeQ#lIT+3 zLhq_eU|ix;<%Xl zyraC_<3{}XIh{Lm$k|k#f3fW%>=2PXYk*WP0eQVylIM;SM$Tq9eA!#(z*FB8qLkl| z#SNINE?kV~u#68Xc;;7T3g6M5hIf;$Zn3s9Ik*kJJ%4*rCbfJ)m7gi07p*fTq-a~8 zGF>jAmTV_gnKFuH-G?;x^(_zx;a+a1y4=dP2!8cLQKU4m-STCNODPd-ku|?swa@|)|Rw4OO z`u&JM#8kGf1BAjq@Y4-4V8@;ukm{=yng$+)HrfCrsX}X!B*`{~+D*!G&#H@<)Nji< zOAl;XZ?H5NOkwi>ox57k1PeZ5;MH6hdn6$EW6!k02mQHwLF<|8kej;1Ea$U1>-M7y z15+bb#e_9uq4|?(gDavPozOXP^@w}J4I!w82fW6CtBIKKKV_+UXjZw9b(3b7k&cv$HZ5#8v4C=*5SgAg)Lok?cFBYGjaUA|Eyds^ikyVx0S~ zw?(XtxzL9IWI4EIZUKq5k4K+7H*}oswYavnIN}d+2V2~_!Id{GZ;N*#OqylgHbA*icStvwZHb; zlor9Qo{zr~G-6J1sbpelsO(uj=DMK)uT#1!XbcuVS={d_#orwr4iggn@qMisEKjCO zks}a}^d}e;EDXk*E=cxT_BoF|>J6D^$Thc{OBr)bh3PXY%b*YwVP(K5ntM`KEV$>C ze}E}}0iFj+=+gtkXm3eMD#qX5be`j1LuItI3T&8`VZz_@b5$~2oa{F(vW4RjSadKQlu8f;_=Zo&CvmLI`gLNjz#NB zG&Na>x%1%iF=h$z9(`Q857N&&9OhAmQR&aoiZiXAy6bZ{8yQeiUrYjRn6c z+GShZgZsB zzZi|jPM6io=l-YHnmbEvbrSM*=8fSiQLZHdzRw^BIrn(Asqj5C75NEe`p#mI=M1yL zg{f)c{^$lVd+#}Q(M~T?8Q{!$s{AV2dwp38?sFUWXHcvl^R>W`O&c$yuY$~*{78?y zLJpC2TWBJiWB^s9sA#5_^{r7*gPRBO;V&T1z+bedu%w%Tyd?45&u!(am~D8 z8E)nQn?a*-`~x9tx$}lIpLr`e0YPOe0;JfTY2C#|(=s*X__=~v!vhk*DL!-sSxs5> z^^|t@{6z>o2MDaX#{%X(VIEoAv8z1+xgX9^nm(MIyT5npq4Tg|g{O7a(xV-*Jq#nE zFU)(%hT>-_X|4X9N5vYsPRV^*c2h>Pg6XB_rW#ghbG9A-0<>w@)}udcvl~4aK7VspDQyrO^Why;C_ZHiSH~+v>E7o<5aWmQ{7NNqwBa9+8eIw^rcTrLUyC3Lzz3 zjMBghzWO236h^bs$9Ym#dFWM}^|Bg;rW$;hQyqL|zW>F6O~??eYbk#u@FX+r`jeT5 zSyPGd+*X3Avoyqnj(_T0)2M>u)}P;`x>XDn`aD>TgJDA@7rhKEhHe4g*rHT0qK>GH z$Jkj_K%krDO%5*@!ehKx*9##E@fLdZz!ZN|JUaKOb?$AwdWt$q^Q`Y5l!*Y>VG{4i zKKueVgJHoN3^@@_`!7CYtZb)v%kM(I}ilG|Tj8Sj->cG%N&7?EZPhq%3Dy`vjD zv+wV!vMJ3gEZqBeGU{hNjS((?BcMqXXiY}$cgJ1`kGVHaM%9-xPKe49$}AWyOXOCl z7qWOKB!xrfhT_b~Rke?qNQSm_W<)Y_C9MC%8}Cj%%&lNH6D(K!vDTe%=fHg_@BmRO zbvDazAXxMlp!jC!z%1+NGOKH;$1-yHNYcD~f#*3!oN#%y1I)7uJ>7F3dzn-PSS;_bZB_tZiQWLK@rjW1coh|eVtX!Iy{4htZTgR&=C$^ zQx}15EN862GAi>=-Gr~A(r$9jUWK)ACb>X2zhSy51t%B$nD~51K)Ha?sZ-Y_#~vCv zOsCK?mW$eT)h#E9&ti0A!)cnnrq~%;|1fKqvvXPZI9MYK>P7CjouENobD89pQ5)*d zphOZHEZnK-eLaLVyqtq4C7n27Ka3@2ndfKw- zH@0KUvtdD?-aJRccZ^w~-t3WmQLURQ%Lgd5MMcE_Y&TgSM7?D8$oMVHRL2&dDUjnd z)kjx}rVI6|2A274Ug)d*eP|69(w{sp)bKOK9- zw2w1!nW2h96ozM06R7cM1-hH44FB>o&bVMG{YV@+!TRbcM(h!Ii@5r@&tCdF9+OlV z!G6R&C};0Ck@}!nzNe}m{%5*QkiL%-wo;_1gj-ffuG;i`(WxghR1o<1ebSYP*?xS@ z-j7E=I0QB?5d;!4xfQ>#V7=0_0v%z=vU0Efhpmg(lCIA1(%SBE%Lr+Vh=>AmP3 z?Thlr1_yoNwiM8s-8i9oa{hW$`#YlEZBm|*GhJsi=Q>{5*1%vdt&5)Bm`gU^dU7U| zPkWhHAuR>i?>6>@9hE>N11$f{+7TZ=ocRcCfc`drUg%QVgV&@Y*ilNXsHC}b05 zU5m*JOowlrS15Bha9i7p+HXoheje_mH5jd$GgaXte&njTP@MMkm0Md5x)h{o|*Dsrij7j>HatJu=ADhov`sE>kQ<2YThb9uWK* zN0Hl93&Hc0Fil)gu`MnoE0}c2EUM59TnO_F1yK2x)UPt`Y|!-E{EsbzmD)OcHMME@|^FeZ%C{E68zW_4p;}|4Do{_ib^Noc@w4 zMziiAyz7uc=Tj#84Gx3SF9_hm#Zd32ZQ@ChN zI#Jv)X7>Y4{@!+??%bngAIaH6;IBw4UHGfHipxizGJi`~%qo1LRaK1a_(~_!uYdIBZV9C8aJ~!kCg9}=^ z{sT}XY6~9OkKpH`?F6%o=am5@lg;pVTiTLN2#MD>qHOui;#?~G%I{5d$2h#l(DQ(x zyZDq^F*M%*q8$QRv*~+ap!{i?f7d~K*InkcfuHru=h=}5$tS$VJ{B)UGXHQiFX-ab zlbvvu0`Ga1+gTgLJ#A4`nX4c^_~}@MC^*WTl(l$SrmoGsc1{R2<2tOpUM?o)S$&6`WFyIP;Dq z+=!BBZ#q4(3kY^#Sh@NYSl#I}t>fzQFpPzhEH w5^}=z@!#OA-6EO&3Nmc#>PJ9zMeIdPj1n^GEG3|u;Qm`A`G5R5zP~g77bvn0c>n+a diff --git a/doc/src/Eqs/angle_class2.tex b/doc/src/Eqs/angle_class2.tex deleted file mode 100644 index e5a542e87a..0000000000 --- a/doc/src/Eqs/angle_class2.tex +++ /dev/null @@ -1,12 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -\begin{eqnarray*} - E & = & E_a + E_{bb} + E_{ba} \\ - E_a & = & K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4 (\theta - \theta_0)^4 \\ - E_{bb} & = & M (r_{ij} - r_1) (r_{jk} - r_2) \\ - E_{ba} & = & N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2 (r_{jk} - r_2) (\theta - \theta_0) -\end{eqnarray*} - -\end{document} \ No newline at end of file diff --git a/doc/src/angle_class2.rst b/doc/src/angle_class2.rst index c7e5eb13ef..b045cc6917 100644 --- a/doc/src/angle_class2.rst +++ b/doc/src/angle_class2.rst @@ -1,22 +1,22 @@ -.. index:: angle\_style class2 +.. index:: angle_style class2 -angle\_style class2 command -=========================== +angle_style class2 command +========================== -angle\_style class2/kk command +angle_style class2/kk command +============================= + +angle_style class2/omp command ============================== -angle\_style class2/omp command -=============================== - -angle\_style class2/p6 command -============================== +angle_style class2/p6 command +============================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style class2 @@ -24,44 +24,49 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style class2 - angle_coeff \* 75.0 + angle_coeff * 75.0 angle_coeff 1 bb 10.5872 1.0119 1.5228 - angle_coeff \* ba 3.6551 24.895 1.0119 1.5228 + angle_coeff * ba 3.6551 24.895 1.0119 1.5228 Description """"""""""" The *class2* angle style uses the potential -.. image:: Eqs/angle_class2.jpg - :align: center +.. math:: -where Ea is the angle term, Ebb is a bond-bond term, and Eba is a -bond-angle term. Theta0 is the equilibrium angle and r1 and r2 are + E & = & E_a + E_{bb} + E_{ba} \\ + E_a & = & K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4 (\theta - \theta_0)^4 \\ + E_{bb} & = & M (r_{ij} - r_1) (r_{jk} - r_2) \\ + E_{ba} & = & N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2 (r_{jk} - r_2) (\theta - \theta_0) + + +where :math:`E_a` is the angle term, :math:`E_{bb}` is a bond-bond term, and :math:`E_{ba}` is a +bond-angle term. :math:`\theta_0` is the equilibrium angle and :math:`r_1` and :math:`r_2` are the equilibrium bond lengths. See :ref:`(Sun) ` for a description of the COMPASS class2 force field. -Coefficients for the Ea, Ebb, and Eba formulas must be defined for +Coefficients for the :math:`E_a`, :math:`E_{bb}`, and :math:`E_{ba}` formulas must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands. -These are the 4 coefficients for the Ea formula: +These are the 4 coefficients for the :math:`E_a` formula: -* theta0 (degrees) -* K2 (energy/radian\^2) -* K3 (energy/radian\^3) -* K4 (energy/radian\^4) +* :math:`\theta_0` (degrees) +* :math:`K_2` (energy/radian\^2) +* :math:`K_3` (energy/radian\^3) +* :math:`K_4` (energy/radian\^4) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of the various K are in per-radian. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of the various :math:`K` are in per-radian. -For the Ebb formula, each line in a :doc:`angle\_coeff ` +For the :math:`E_{bb}` formula, each line in a :doc:`angle\_coeff ` command in the input script lists 4 coefficients, the first of which is "bb" to indicate they are BondBond coefficients. In a data file, these coefficients should be listed under a "BondBond Coeffs" heading @@ -69,11 +74,11 @@ and you must leave out the "bb", i.e. only list 3 coefficients after the angle type. * bb -* M (energy/distance\^2) -* r1 (distance) -* r2 (distance) +* :math:`M` (energy/distance\^2) +* :math:`r_1` (distance) +* :math:`r_2` (distance) -For the Eba formula, each line in a :doc:`angle\_coeff ` +For the :math:`E_{ba}` formula, each line in a :doc:`angle\_coeff ` command in the input script lists 5 coefficients, the first of which is "ba" to indicate they are BondAngle coefficients. In a data file, these coefficients should be listed under a "BondAngle Coeffs" heading @@ -81,13 +86,13 @@ and you must leave out the "ba", i.e. only list 4 coefficients after the angle type. * ba -* N1 (energy/distance\^2) -* N2 (energy/distance\^2) -* r1 (distance) -* r2 (distance) +* :math:`N_1` (energy/distance\^2) +* :math:`N_2` (energy/distance\^2) +* :math:`r_1` (distance) +* :math:`r_2` (distance) -The theta0 value in the Eba formula is not specified, since it is the -same value from the Ea formula. +The :math:`\theta_0` value in the :math:`E_{ba}` formula is not specified, +since it is the same value from the :math:`E_a` formula. ---------- @@ -117,17 +122,19 @@ instructions on how to use the accelerated styles effectively. The *class2/p6* angle style uses the *class2* potential expanded to sixth order: -.. image:: Eqs/angle_class2_p6.jpg - :align: center +.. math:: -In this expanded term 6 coefficients for the Ea formula need to be set: + E_{a} = K_2\left(\theta - \theta_0\right)^2 + K_3\left(\theta - \theta_0\right)^3 + K_4\left(\theta - \theta_0\right)^4 + K_5\left(\theta - \theta_0\right)^5 + K_6\left(\theta - \theta_0\right)^6 -* theta0 (degrees) -* K2 (energy/radian\^2) -* K3 (energy/radian\^3) -* K4 (energy/radian\^4) -* K5 (energy/radian\^5) -* K6 (energy/radian\^6) + +In this expanded term 6 coefficients for the :math:`E_a` formula need to be set: + +* :math:`\theta_0` (degrees) +* :math:`K_2` (energy/radian\^2) +* :math:`K_3` (energy/radian\^3) +* :math:`K_4` (energy/radian\^4) +* :math:`K_5` (energy/radian\^5) +* :math:`K_6` (energy/radian\^6) The bond-bond and bond-angle terms remain unchanged. @@ -160,8 +167,3 @@ Related commands **(Sun)** Sun, J Phys Chem B 102, 7338-7364 (1998). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_class2.txt b/doc/txt/angle_class2.txt deleted file mode 100644 index 5a772f8fa9..0000000000 --- a/doc/txt/angle_class2.txt +++ /dev/null @@ -1,138 +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 - -angle_style class2 command :h3 -angle_style class2/kk command :h3 -angle_style class2/omp command :h3 -angle_style class2/p6 command :h3 - -[Syntax:] - -angle_style class2 :pre - -[Examples:] - -angle_style class2 -angle_coeff * 75.0 -angle_coeff 1 bb 10.5872 1.0119 1.5228 -angle_coeff * ba 3.6551 24.895 1.0119 1.5228 :pre - -[Description:] - -The {class2} angle style uses the potential - -:c,image(Eqs/angle_class2.jpg) - -where Ea is the angle term, Ebb is a bond-bond term, and Eba is a -bond-angle term. Theta0 is the equilibrium angle and r1 and r2 are -the equilibrium bond lengths. - -See "(Sun)"_#angle-Sun for a description of the COMPASS class2 force field. - -Coefficients for the Ea, Ebb, and Eba formulas must be defined for -each angle type via the "angle_coeff"_angle_coeff.html command as in -the example above, or in the data file or restart files read by the -"read_data"_read_data.html or "read_restart"_read_restart.html -commands. - -These are the 4 coefficients for the Ea formula: - -theta0 (degrees) -K2 (energy/radian^2) -K3 (energy/radian^3) -K4 (energy/radian^4) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of the various K are in per-radian. - -For the Ebb formula, each line in a "angle_coeff"_angle_coeff.html -command in the input script lists 4 coefficients, the first of which -is "bb" to indicate they are BondBond coefficients. In a data file, -these coefficients should be listed under a "BondBond Coeffs" heading -and you must leave out the "bb", i.e. only list 3 coefficients after -the angle type. - -bb -M (energy/distance^2) -r1 (distance) -r2 (distance) :ul - -For the Eba formula, each line in a "angle_coeff"_angle_coeff.html -command in the input script lists 5 coefficients, the first of which -is "ba" to indicate they are BondAngle coefficients. In a data file, -these coefficients should be listed under a "BondAngle Coeffs" heading -and you must leave out the "ba", i.e. only list 4 coefficients after -the angle type. - -ba -N1 (energy/distance^2) -N2 (energy/distance^2) -r1 (distance) -r2 (distance) :ul - -The theta0 value in the Eba formula is not specified, since it is the -same value from the Ea formula. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -The {class2/p6} angle style uses the {class2} potential expanded to sixth order: - -:c,image(Eqs/angle_class2_p6.jpg) - -In this expanded term 6 coefficients for the Ea formula need to be set: - -theta0 (degrees) -K2 (energy/radian^2) -K3 (energy/radian^3) -K4 (energy/radian^4) -K5 (energy/radian^5) -K6 (energy/radian^6) :ul - -The bond-bond and bond-angle terms remain unchanged. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the CLASS2 -package. For the {class2/p6} style LAMMPS needs to be built with the -USER-MOFFF package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none - -:line - -:link(angle-Sun) -[(Sun)] Sun, J Phys Chem B 102, 7338-7364 (1998). From c25f8b21203f3013fdabe7ffe4aabe3235dcbf86 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:43:27 -0500 Subject: [PATCH 405/557] Update docs: angle_cosine --- doc/src/Eqs/angle_cosine.jpg | Bin 2380 -> 0 bytes doc/src/Eqs/angle_cosine.tex | 9 ----- doc/src/angle_cosine.rst | 35 ++++++++--------- doc/txt/angle_cosine.txt | 71 ----------------------------------- 4 files changed, 16 insertions(+), 99 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine.jpg delete mode 100644 doc/src/Eqs/angle_cosine.tex delete mode 100644 doc/txt/angle_cosine.txt diff --git a/doc/src/Eqs/angle_cosine.jpg b/doc/src/Eqs/angle_cosine.jpg deleted file mode 100644 index 23b9b6431019dfc432e113da50fc9056438cdd9a..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2380 zcma)8dpOe#8~%-L%$XUo9LB`VawN2~m;XkQNt*Nytje$;nE~%EA?PE5hZK5wfyMC?#bT6*VPY&oV_D5>p8=M zF+lX+)klHtYyy#1g!vzoyu^M#luRC7A-SBU(arDM&X0$T4~#7&kz3-enYMU>J086S zop-|!Hhb>By!bOil}w|!4(OmMvw@ZV4!#g2&iU)w3*lTub$&&{Y-gB7>iee)(Q@Mc zAqXM!YtbXY`!ijPG|^+uhQqcIWZYZzBYgox1%?hP7=>}CQH9y|R9DWwJsnBR4n&pM z?BESOgV_6y7U;6$S{NXTn4}KAg+~Lh{knx6%{*-l%L4m*#v{FU9mcmgROwpF$S7WC zR}(dqYQ`Psz^6~zBIgUcEIf>2fGF(`%rA{B2gAzLk#vm!W-vkbw)Tkcfj!7K5B(={ zRbV<180X=L28s)ZN+Qy#2U8@>mOlH^2cA88{!%aal``z)bGF=KnV3FvGH^jh9h^By z`ZiAK(oUE)2wlwTyHLlPkFuGw%WK#l#2diCD zG&y4P(A+vvhUK#1eRmHh%v2!(5h4l$F&JRXkJ#{{(#q2K)S3K`z^YTW!t<4&$hp0% z&^HnjC1xeXuH25p7uG6X(t(4veV9bfsVe`_i+iP%%3y$RT1ny zDOb7{3U%6)t?&p~g!V4E5MJw>cK>9_s*D;dH9Re@lJmA9Rd%`9aOrxI2=oolJlf`b zv71rg{`ODb_d49)?gwo`c??{JIlX;LRLc*KL~439cd{#M;h|E!j@nFeM2RsD zLhlYFpk6_u3*zIY2KxCMhzO|M!h?%OXbZ+=f7rcKO5E>`G&cQPV*imq-L|P zsq)Ipg0~NK+2F9w`^HX{y6Jw?uLZy^u`L20)-rRPQg@nOR)!JoK|mjF%_&@8Sn3>PFKg~(7;o(v zCz%nOTlqotEVocxV>}%fU`#GB$&K%6~C~+k%)XFou<`r@& z1XaK!TsotI690b51K-_gh)==S^A*+~^@kQg;!Wjf2Hgfr{W8=t&nWw~n`0wn)ng<( z%lmXHI+h-dor*!+{wcJu;}RkOeq^+71h$x9%iS#7p&MfR3a(^^ISs9-B}H@BTRk|K zdY{b_$>@;X9=L(^3dR(N?Wk!LR2gd*E~95`3LLsQP5My!fc@0i<4KE z1pu@rJ9nT~r{}WjEk^B-j2IGn$VW@dA-Uch+I!?%;E>bMG|0C}Oh2KCxSE92<;LCt zB)_zKigdJIdy_BOX8)KIdNSWwHyt+mHB2W{R7+p+{n488kw?xZ z&=LrVv25b>^A+LtF=S1m|A4_lvEIs{@<8bMClJZAFC>pS|%04$o2jGUc9)Ecta+DrPXh=%K#cL8) ztvrHht^Pksi z{;2NpSM0+ze#*k*VCiSRT9{4h8<~q_BG)`@qfQzD(X<#*EZ8 z?{k??7QmmUKbUj}(G7rf)TcY7ToKR9vd@G+5UZRv6ith9YzhA-y<)f%{(IHar@{+t zUR{5DzH)_GP11BJsDpg1`F@dKh&wp2ugVAXxczYI8doK?Ps*#fvyR7SJ2;$uZDXkr z#cu$$?L^>dJoIrk^TEBQY>zN3HZC-kbA|TZRvyt$+bAP5QOBe{>V^Q0MBViTzk0X3 zHlG9H%feImtqxuSVruB1xDGOae#sI9W!p8QF-kfiVRO!cCPGN?CkGv zhW` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) +* :math:`K` (energy) ---------- @@ -83,8 +85,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine.txt b/doc/txt/angle_cosine.txt deleted file mode 100644 index 93fed32c38..0000000000 --- a/doc/txt/angle_cosine.txt +++ /dev/null @@ -1,71 +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 - -angle_style cosine command :h3 -angle_style cosine/omp command :h3 -angle_style cosine/kk command :h3 - -[Syntax:] - -angle_style cosine :pre - -[Examples:] - -angle_style cosine -angle_coeff * 75.0 :pre - -[Description:] - -The {cosine} angle style uses the potential - -:c,image(Eqs/angle_cosine.jpg) - -where K is defined for each angle type. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From 00fc015e4c338385a400cfffbbd6bb0394224ccd Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:47:56 -0500 Subject: [PATCH 406/557] Update docs: angle_cosine_buck6d --- doc/src/Eqs/angle_cosine_buck6d.jpg | Bin 5374 -> 0 bytes doc/src/Eqs/angle_cosine_buck6d.tex | 15 ------- doc/src/angle_cosine_buck6d.rst | 32 ++++++-------- doc/txt/angle_cosine_buck6d.txt | 65 ---------------------------- 4 files changed, 14 insertions(+), 98 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_buck6d.jpg delete mode 100644 doc/src/Eqs/angle_cosine_buck6d.tex delete mode 100644 doc/txt/angle_cosine_buck6d.txt diff --git a/doc/src/Eqs/angle_cosine_buck6d.jpg b/doc/src/Eqs/angle_cosine_buck6d.jpg deleted file mode 100644 index 69b668c08603ba4a137317817d16fc2394ec3a41..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5374 zcmbW4cT`hZ*Z(g~AU1FW$I2t1pbUoe#9_bysgNGhP??05-b0EARxIsi~8z+wOZya1Ox3E=MZoKt{VP6Gh<{9M2j06Z*CpMKZ{ zaC7!9-^LHS{%7Xb!*2iaXMPL9vSLZ3Z#@=^C%~ja5r>*8!ZY#sIJiY;hRRuC3aFSv z7OG;>P$m|MtC#aqNMeyFLW0ns_zAjHZKfV2Co4fHG|IqJYGE)P6r)3np%GA)#Ei`( z5ODF7L=FL!iI<`osSJLENsOUT_#_Hfogk$X@i7q;N}O3l0GVRbsI*L-RHeWvsNi&p zf-P5OX3|ncVPpYML_?Th6e>S0UZvr|Bm$}!lOb0?1!A>WZ<2v6a;5>qMj6yQd zAdv=vTpy!kBlU>}1B#oe(d)rXL>ekBg_};dX!TGG1EwRGjA0mZ92kvfz-bzt0u-TD ztI-h(m@JhJfrxkzi;}B1s~KP&(Lh6_MF_%#U`3or&QYdnp@}*=k||GRr=Sf4DT9w1& zvSSfyfkI7UYb7{S1RRGWTVlfaW+G0L!bpz?(M&0{IHFw6BXCVL0|`xw(<%%o1y@B9 zBJ?y8!lJM+6XJvka=DVnk}|~_t&Bo}We8Y8HeD9RHG!~NE?jL;>r`x{P=`?H_- zi(?7NDJG~EAEOXO5Y=)u5+{=~^kGbSN<2@WDP>6+QUXj#f#DG#ij0bYW}?76og866 zK}b?b3Xz||qndFVnOLqt#FLe5JQuE^lQD9ZEZ#zn#UOcNb)uflB6B!IHV6_=(#Rt; zx&)(A1y3iCO^N9^v5rGDC5o8%OcF6YCLu%5qS1-GL_&s|A~rA(Ds+UAB?Gh7R01yn zr01Zy5GgM)5vq`z%^aagC}M~Sat1`eq_EMLM2d+ag=tjsOc7ox)5kE`ESOr1*CO~j zqgKfWvq4-=x+Q^aRL1KWJU9j=3ey@0F%mUTD~(Z7y1_GW!kn?a(%53U} zEmW`)p(1dFyx3S(hFPEzn^7t;4`l=~G8ig#EG{92m%&o1@Jcva29FI(&q(8C#PC!s z9-PU66IrNO1sDs>#L_d3nVCi`&qy+ZvCMR=fCqweGvRn85~~cu^ANaLss;;zs1&F~ zDOe~5b2AuHA(o8CB@l7AM4?U`LrhC&B&LZqsZ2#WBTd92ff6(c3BnjTMyf?%IT!-Z zK$7s#F`4iLo{`K$i!$L{9y(rxjOBodurORInwTDj6NSa3qX}Sm9N5SMX;>Uugp7}r z;1Zy+44j#fNRlz+EC~)y=L^VioeWQx#l^`JENTMJOjMfVF6Qy|c$;JN^WGy?~j(S2veHz}45q&DX`z2n0B*y@$(peGhXs zF0O9w9uqvhyg?J46RLdxR~I)oS9doLk8iheS?wGL+*Lj2dXZ$#G)`Ep0p^Fy75l9povotmihbIt8WEMM-!{zY>DXD4c z8Dfc4r#EC8O=ipb4I6XwHf`RLU$AFy;lAJY7acuzyyQgb$y28*t1eXkQFHOq<@$!k z>rFRq-n!k|*8ZU5VdtZ+UR&Su7cXDEe)IRx`{55CM?Tp{KY!zLe#!ogQN|GBz>SitqW++1DVJlx#eJSKQJHNk7bH+g})z6_Xh?(XS4eI|NO^!Z=Q@x-|y@NskjliXaKi^K7(&MOM=I*(jH+$!#BJe(2Pr+Osq# zY0~r7j#pG#5M{r=4RbW4|EIUZO$~=8$XK;o!~0@{PxsM3ZzYbPb>Pb^)+jzAZT zFYVyhW?TRG1votQ)a&x~(Y<23=hq!w;O2(tvGvJ%-n>otJY9qRQi;qu88v{xz+E0mBYKv<`GovzxLI{MAH^#TUEquPk=sd}d|`N< zxqNe7>dtKe)3cY@;~VSzzXq8OB<#G_m05G9Q<6K|uPW&vjJB(BU)%lRi!pa+YfplZ zA7Aa1jh~7N&Z$2-elR;QD{e>f!dHYAW!Hn@Z7UNFQOcu+FN4P3423kPwgyyj->C*y z+58S22|hm-c)8V3CTqyt;!)C6{PT?VN!N1UoMR@fkH~CP_upRlVVLLk0e`I)X{xh% z5BYB|>k>y#nTC!$5O!}-apKk8y#2rbObK}O%+U42-A%ViBF6MZQUUe1u2=mi+nKAe ztOt`;&T4_rl*?`H1H!hB_*d}zfQwWZ!chNx}FeLt4Z8r(PbyRotO3t&oe00e2f%dNko=S1d|WVd|v zwuhgwOK;Fxt$blwa(GwI)q5=~e!`tMi$eRhns)`%EehJXXGivl^1Ry6oLi$~Qyf5r z>U#0**4o~~u9uQ0m>Nh!9UHQ+M>lgG_8U8LYUyP!C7+m&ZmYdV6LwXw4sqSrnC2ks z`czw&W>*-}j*KA{g8CWVlRF>u|7&<(z^Xf%OWC=#S>wf7#-ZGYy%k$&_Fo^KcK{0e zc58G00rXd6M>)SuHfd}JIpatZ!JY2;xSf+-pjmA$>00r3Va}sZ1#vqOHNRDkLZRzg z29o#waR@bKDkFJr7PzB2x(j7{*!U!+@jW@qbMUQTUwsj0S0yxQ#ozvm%TD&JJlfa) zidYl2@L9J1(5uGi0Mn}LUl&){OOO0rSTtk1p?g)1_ZYcl-efMV z)1ATZ zj#VjkM9_|02UcU#By%_J@rOj_FR)5xU8satMqt;hcwCr{e(_sAEx3Sl#x}K^Z>6O? z8%L@p$)KI4yhcIo+TN#=M;GkslJ5JwN2M_lf1O*{5jZ301$J>hlRLf6XK&WrFL7i3 zgFDv`{1fy5e7xgh&a{=y>VG~h4d1>V|ME+4SkQ`Q?+rfF7A8Mg92&N4Ud<5LmRsf7 zSO*#d4Y~!I4m7H1r;~e@de0!WgwISVd?g$eNJ`SyJx0wUTTwEfD+?(w6w zh$r@rFZD$^x##o)lN)~W<&)2Mz7gn+`;xZ5sBUV9KAxFPxpXTeGUYD^@N3Rwdv5o$ zrjjAl_56FtvZ3Ua?UB5u7rr6>53dJSO$lNz6LkIfy#Dmbr)xaPz?aM|y^$*0)LE|= zrT0u8JTerUusp%z19ByC#T9D$m+nf7{>Cq|H4b3o#-S@;H^Usjv-fw#Lfv}KG)DbA zCMfQu<-t#Wm>B#ZE6LVR?T-EHr_^-biS{M$;|lhU7WVWY%qN8R8~^2VUDj$1Ic>`0 zwd8-gK5PEq_!roO3n<7F1wETH95_ntz5g?}v2J?g&t+qj@hf9fd%IU;4rBkYo1dL= z06yK#lDXEiV1umr-P0?ENiEZU-GR;DP%c-(UHYS@+1J`u&mP%u**?{_nrGj5d~k2g z=9DX@z#7xb8I}CyP1F1meJ;K4TA;XpQQaDak18y`3(j4+u%NzpdQ^0F`yprtI4kjp zJ^5XfXG=&?nD|_I+WCFs3%zQar~B9_)aOY}-7)`6;$IA2U2`If+TI^E|4sBHtND1+ z>(4ct;CIU6sjK3ftTn$&20$y935em3Qn&W|LdT9TEyS!iPWK3hHC`^?Pzxmub}zq_ zKO8@_;$TPBQ5sB{KeH@&yJ6zA8~N*-x2(!~zEMIK1}=+8X`9{f^uqWCOLpn$UrIMw zVP|`uJbElO)^L)=)mPhswh$E|`=8Y;E+9s0H+iKL)sG+PNdj*!t{OQdqIF02B8r;b z)+x?i2&XlBju-Fd?W9kohn;`m0G_`ZTjT&l#!WdN`i|2*9e<6}E{yMOZMMB|05`n8 zhM3C6R-BZOj$XZUF85|pmUeR^q)}hCDe{_i7nDj`c)8H-hAi#NnQCfo%JI#j*iKqu z>W76E%3H}UNwE}C8Qc~tEbX#3`}Yr-^CJi@Yi^bw2|et(<=-~-P_#JuQ5$jmm=)Or z8p_#nr-ZlkHK5!#o5+XWx z*1%>1GLK(X*fh+HJ3pfhs|Jxv1TAIw528H9#Xp}5Yo#B$Lfx9aPRN>7VW0eLc0lgs zfX#@VKCds6z2pELoE;c<=6R$-T-~hkA zS%hm_13+)HLmpTsmM7bl0Y4`Hapt6;JN#@#j+iuy5PmmWypA>dZV)SUbl3UEe!L1* z#?dvAOZ%Roaus8={ zEMqL27gU-B8hmjmuh#*1K7RW6iHTc3kg;ILj=&2wRZmMRZ%JFrtiG^O=+T>7Kqo#j zZ#Sl2db({SdT^6{_|K>Fra?x)lV7*6i-K6=E!BO%JYfjYe zI{PH!>#|QzKh`IYyZ`0s*0*zG_B?x@t=P>}m2~N1$e%^qE?4ipATLfY`a7N<&Uon& zkJ?jNMX264`PNNag*9mqT)z@xU-Q%#F?;LD@^gAt@7vB4@z{Z@;pd{-JKlTZ4cx4= zxk%<~azXv>wygOMAfNWE{EMrk?lWbsWiDU>Z>q~E_cRqcfa?Kr>(xBm(Det^FYAui z50#xLL0o`z+c@v<-kH-9JB>DrcxLh8$qnS-Phw$i&-9ua+?LQiiv!o3K7Gvjw+BpF zcl_uYP^i=17yFNev{~bAH^&U6(oa2eALj0h+P>iBA>nXv#Ub_q;jnE_*p0w{Hn+Q8 zDL#k)MX&`J4e5J&4gJH2=%QUXxR3C@Z}9PD>Jee-viQh8V!Ps_cc91p)FREqvHRVJ zICmhyMTYU;9e`i7gqB+yIe6C?cG&a-?qSb}&DOChQC61mPLq@rdeCRT-~9bAmcjg| zN44Ib+Odc3d9Ul>Z}z=k;>0Nb(+gXorYH5#BFE`(yN(BX{Yt&we|BZYzAtr>t+me( zA9F@A4gi$XdC(Rxj(+3UmNnM_?B+5YfOCiBtTg?G` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands in the following order: -* K (energy) -* n -* Theta0 (degrees) +* :math:`K` (energy) +* :math:`n` +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians internally. Additional to the cosine term the *cosine/buck6d* angle style computes @@ -73,8 +74,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_buck6d.txt b/doc/txt/angle_cosine_buck6d.txt deleted file mode 100644 index 1ce3556ea6..0000000000 --- a/doc/txt/angle_cosine_buck6d.txt +++ /dev/null @@ -1,65 +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 - -angle_style cosine/buck6d command :h3 - -[Syntax:] - -angle_style cosine/buck6d :pre - -[Examples:] - -angle_style cosine/buck6d -angle_coeff 1 cosine/buck6d 1.978350 4 180.000000 :pre - -[Description:] - -The {cosine/buck6d} angle style uses the potential - -:c,image(Eqs/angle_cosine_buck6d.jpg) - -where K is the energy constant, n is the periodic multiplicity and -Theta0 is the equilibrium angle. - -The coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands in the following order: - -K (energy) -n -Theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally. - -Additional to the cosine term the {cosine/buck6d} angle style computes -the short range (vdW) interaction belonging to the -"pair_buck6d"_pair_buck6d_coul_gauss.html between the end atoms of the -angle. For this reason this angle style only works in combination -with the "pair_buck6d"_pair_buck6d_coul_gauss.html styles and needs -the "special_bonds"_special_bonds.html 1-3 interactions to be weighted -0.0 to prevent double counting. - -:line - -[Restrictions:] - -{cosine/buck6d} can only be used in combination with the -"pair_buck6d"_pair_buck6d_coul_gauss.html style and with a -"special_bonds"_special_bonds.html 0.0 weighting of 1-3 interactions. - -This angle style can only be used if LAMMPS was built with the -USER-MOFFF package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From 71304c3b8c121b41781e92c12cbb0cd5f83d9b74 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:52:29 -0500 Subject: [PATCH 407/557] Update docs: angle_cosine_delta --- doc/src/Eqs/angle_cosine_delta.jpg | Bin 2576 -> 0 bytes doc/src/Eqs/angle_cosine_delta.tex | 9 ---- doc/src/angle_cosine_delta.rst | 37 +++++++------- doc/txt/angle_cosine_delta.txt | 76 ----------------------------- 4 files changed, 17 insertions(+), 105 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_delta.jpg delete mode 100644 doc/src/Eqs/angle_cosine_delta.tex delete mode 100644 doc/txt/angle_cosine_delta.txt diff --git a/doc/src/Eqs/angle_cosine_delta.jpg b/doc/src/Eqs/angle_cosine_delta.jpg deleted file mode 100644 index c6e90bb2c5a7a9f91e93ffadc9f9d31e776f1f7d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2576 zcmZuzc{tPy7ye-w2FZTISO*PRZy{s3mMk;bCKOYaP`1I?vX`x>7{=gc9~t|Wm_dw+ z7*xt0B9qWi)>2XP=|120*LUA@p7T8CyyrR3Ie(p(HO+bl97S4KTL5fqY=G6F0jycT z4B+Gdfj}Ibhk=umlMBqp4L*bbFE0j5O;pz{?HjvGKF92?DG>Knh?3IR0_qe>fZqVq@pvK4cL`0XB}q1jNAs z;o|t+a7cgvPA)+qu$-`nmI=4KgSM%ssF=9IDJSQ|yzxJAp<$7&1k!8P48VQ3IA9F? z%txY$WcdGuI&tZ;Md!7l`mvUP0CABGob%=uBBsQs%4v~CdbifzOSxM-B+AJC%)R!Iaq+Vqb>X%fdK+KNU;8+x0ol-p+K#*t~ z)N(Ic^wz90m2?-mu^4jDsNC@v6dzOInD&vFb~~OV*9Y%A>3q6|2M)29u3)c7itiAp zZff{_TqEkmkZ8%|&mqQM^0Aa{*Y;eQOMsA$W4RTZtdKRpZWGVwtYWloPvcVcZj_G| zEGJoft258Qo0VI>cZi%Td4}uYjYA||%4%(|q@4j7NZO-P+p?d%RFPFp)K{j}UM7;w z=2~J!Dc7?LLr`{{I{8Lt;C%U_&zc#J;lTxulw^YeOhw616xlc zXHn<9!;Hh>u2x2cvXRr(2YX7kav3k^Fqg*j$L+lkD(=}QwtXsJIg^jBr7d{GDqr2K z`GL+&oCysu>k;XonM4w{<-H<(DOPpnSKX}9BY(#or0c`=t>^LI6J6uG?K>0iT+mpo zs8k`hMI@0a(eR2Iq|aj!HtTafDnByKohWtqt5L}sYWcyNqwoFU_Diux!!5}%3D*~U z`ZRmCjSuQ1k5KmcX+uwEadN))d!RsxMCKLqyQr#rTxZL(uz4#>6oGkHd!+Ee1nFQ+ zb+uu8AvJuzs#wQ!S6RO6X~c%;*YQeB-2LaY-0FDhIR*>3MVG0u!>&gLz$7tEgMOSJ zN5g&2#-7=u?=F>rJr}G2MZ_z>DYmk-ZKw3R3JYMKscn^1YaH1^fiRw=RO8g=nBh0* zIinc$4!C(v6Sicc5lyU}=+(G;w=Jr;R(KE7t7YC{(^^4l&p4iy#2gQY&<)UR4zKk& zx^W6MdQbWl-S6h+G3GMJxEaR#x&kTwv{io^(4552b00FCI*S9*(U>!oASYV7OZ zGI&;?*!~GwG7`lLcVM&#HN;e8mo;Pw7#z$|eIL1DDLhjsY)vR8n*O;}3Wpo7(9e5C z=HGG^EB(8IkW*%no=Lx=!~({PwEIlE?&DzI+7ikS&bbLYj5amq%h>`6J8+{3$t}g4 z+L7BBt?9AnJkd5U>dqG++iOqw#ErUvnR!V!jGlSyJ3{C8J@O}MIbIi1(mwZ5bweYT z?+3~ogqy1A5R6h$Rx%$OI*HZlWlIl2)}_A?pWEqRLy8Cv-BGD<#p7Tm+0Xc8kHNC| zzE97h#d|)tV}vU6ENDvH#@97#~l5m(JmrNNaTCavSvuzzY>o7%G^B}7xv4EJ? z3u;5{^Ph2QuZ1EQ^l&-YYKcNZt-d}-$HZkB-Z!?Yyg>Ux3t!0~wrgo`keZ(DGbiD< z%$rFhL6Ag9cnU1>(@^V?67R@*!slwe0_G7)kwm4IwzdR%-?W4uMj#Cf~uMP zHu0mb#d8HhVBYt>uofsvn2~y5(58r3hom&~Own%sN}?s8jDIQhU$0vDwOx3Pb2>_dOqB}Uc=DHwuUbntEaq#&pP(V^ z={yYx3%Hs!TW{?L!FYN!q!Lrb@(j_f+mc|5a(%yj_tPwZ(DbXqwc=u!fpt?lU07bP|KeP3 zRWT3btU=zQAgK%(J4+)fH*ZvA6z9wpEdG@6D(!k`yoR9eoeHG(`SWqfX;w{+@snHO zdy_jUY-Ns&LG;K35>^@-p!n>SW(n=;n6_oM&_b>}=+UKq)Ap8@VWc0O8FEnLYJ1z> zcF1;sG}YundKA~j_^yQD9MqW$(@c-Z`#WQM2RGKd^NB2*4?(4TT~Oy$h^KB$t|+Wb zt_K|J3p#P}N=KGy!A^7WkxHp6&KEH+;RtS-tv%0u8Ez*rm4&G!smAge=1zoX5m`=KpeCu-(l|>Ev*wjN+|AyEp!* zpl3KNeyMG3GjOct)pS5TRA(^Ajw&$~cu+mM5aG$ME4RAJzpdOnW4{U7&oZ3mS(H79Dv=J2;xN*Q%jg7Z}_9U@g2#NoV*mrwVM~ za_32t@0a|nU1RY+{29s91@#FTS|jr=rC*9?_X~0cH1}<8##BDZ&+1|psu4%%$~M8~ z$<4DHYO-HtG$o{(R&xpp%u#nCGE>GJr)KAbP!bUb$`zQyQ%a{9&wCiTA(!AX}Z;~M3|v5V1^(;4Qak&dfl z2hJkHXPZ)4S_d2LT@spLebIoC;dwH1z2} zwEv8@PNDEk_sLwpIzoCaI~uV z%LKls9wLQ~Cz|3b@nC1{Ij2#{dBr>LTdF#A29>7x(;Ay+{`dg3q0&1UC$pOofxkqf Q|3wk~n@aj!JI{La9}+FXn*aa+ diff --git a/doc/src/Eqs/angle_cosine_delta.tex b/doc/src/Eqs/angle_cosine_delta.tex deleted file mode 100644 index 918e9e5046..0000000000 --- a/doc/src/Eqs/angle_cosine_delta.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K [1 - \cos(\theta - \theta_0)] -$$ - -\end{document} diff --git a/doc/src/angle_cosine_delta.rst b/doc/src/angle_cosine_delta.rst index be8f209145..9af93cb06a 100644 --- a/doc/src/angle_cosine_delta.rst +++ b/doc/src/angle_cosine_delta.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style cosine/delta +.. index:: angle_style cosine/delta -angle\_style cosine/delta command -================================= +angle_style cosine/delta command +================================ -angle\_style cosine/delta/omp command -===================================== +angle_style cosine/delta/omp command +==================================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/delta @@ -18,31 +18,33 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/delta - angle_coeff 2\*4 75.0 100.0 + angle_coeff 2*4 75.0 100.0 Description """"""""""" The *cosine/delta* angle style uses the potential -.. image:: Eqs/angle_cosine_delta.jpg - :align: center +.. math:: -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. + E = K [1 - \cos(\theta - \theta_0)] + + +where :math:`\theta_0` is the equilibrium value of the angle, and :math:`K` is a +prefactor. Note that the usual 1/2 factor is included in :math:`K`. The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) -* theta0 (degrees) +* :math:`K` (energy) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians internally. @@ -85,8 +87,3 @@ Related commands :doc:`angle\_coeff `, :doc:`angle\_style cosine/squared ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_delta.txt b/doc/txt/angle_cosine_delta.txt deleted file mode 100644 index 1532e39b31..0000000000 --- a/doc/txt/angle_cosine_delta.txt +++ /dev/null @@ -1,76 +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 - -angle_style cosine/delta command :h3 -angle_style cosine/delta/omp command :h3 - -[Syntax:] - -angle_style cosine/delta :pre - -[Examples:] - -angle_style cosine/delta -angle_coeff 2*4 75.0 100.0 :pre - -[Description:] - -The {cosine/delta} angle style uses the potential - -:c,image(Eqs/angle_cosine_delta.jpg) - -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html, "angle_style -cosine/squared"_angle_cosine_squared.html - -[Default:] none From c4511cb2fc2eea7c5ebd9b4eca7fe35136b6b383 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 15:59:40 -0500 Subject: [PATCH 408/557] Update docs: angle_cosine_periodic --- doc/src/Eqs/angle_cosine_periodic.jpg | Bin 3362 -> 0 bytes doc/src/Eqs/angle_cosine_periodic.tex | 9 --- doc/src/angle_cosine_periodic.rst | 45 ++++++------- doc/txt/angle_cosine_periodic.txt | 89 -------------------------- 4 files changed, 21 insertions(+), 122 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_periodic.jpg delete mode 100644 doc/src/Eqs/angle_cosine_periodic.tex delete mode 100644 doc/txt/angle_cosine_periodic.txt diff --git a/doc/src/Eqs/angle_cosine_periodic.jpg b/doc/src/Eqs/angle_cosine_periodic.jpg deleted file mode 100644 index a9d7d50cb3ab79f3dafd7c2c76d0338080defedd..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3362 zcmb7Hc{J1w7ye;1Br#*(4TFXdiO3d}G4{P?Bn-+jG$m^y*&>WFjFhaCEF=5aw=9w6 zwPlTL*@^5bUw!90-~aD(&w0*0=RW5?=iI-Zdop_R6<|l*(7yrD(a{0OKLwmj0J;Dp z0|*3SVEjXjjEtwiXPCf$z{bMDdg+kaM5DsoZ9u7`^E(nAd#>+1xBqAch!6OD2 z6NU>4iwK`I0W3^_I-Ld`9RxUO1q1;)fS%#6$N#~2iU9gT-HSiY-XwFtMGmFBp1dVvaF%Nm6$hpf>*^ULzDuL8Tha6`U2TtwQ?@h(M zMW8HQOade0#++_1(hzv8D0NOKTrEeG9u;k_l0gR_4j3MKB{9$`yiY$u{8-uPpvXt~ zlC0A*F7BX@)Heh9@`KXDZ(6!>^|(d_%Sj7Ob=>KW&% z`RmG-P>x(xdUN#b!lwVqGRi!OgE%!&MuX&B$a}chAg&XggqN$%$}T%FB~ei3<=&(;dhat8((6tUP7y2^@_7nM`W#S)W9qJ*q|({a5w`2nQ&uZ|2-S=`j}hHqV7I9laj2nh0M zWDJv)(+P`bE?ThPyc)QseK-;ji}OKy3~sb(-E46ue!wEPtf#pWmcO7kx2T8P7H0)Y zNrM{^gC8@KKgHN&AUBM(gGysh0PW7k9E}qozXvSsXxpAG`H7%(+Z2iU++iAaly~hO z8@kwrXX)YMyXs1VVVRVz?AABCWPWG8d$D{}upM%n<&mA+j{(0;tKsb!w0z3&K-V(T zbB1*(Us?dT9GY0NCA2!F;U0@E#uOH}XJck7xDu$YtQito2lNHEl}-Sj-e7;5-$YrP zR%CGliMtZk?sD;tqstpsW%jg}{XX6@c>|;(%uYcqvT{df|1?;_R^GWl>BivxYg;nI zb@7o<^3MV<@lWGT7ns&C_}WajX$S;cEfG42?9`z*uRbf~Tp7YZ3{ey5&6KSq2k7nG ztF88`QF&M+1}X?i?R{oq80?06bpU#Z*4`1&bg7AxzZ(-j=QF_x4{N8jd0w<5?rBGo zdccI^n8PK7<8-blH&n||4#gcgZ_0i;+DBuiUU(StWJU1U7_?{#zX_dEA25UAY7PxQ zKu`?r-wy~$c$h;eb+rUxQ)}UCSQu0k9(}7-Wy9QFdX|C=4i$*wX6FPzRhC)ar$U(F z2^-w{T^Yb9%@ruDx$EArLvQp<`6$o@Ur7sDbibACz zUBif)V2=XqS6_>IF0)wokNEyyJ&`c-X|-U5Bs^h2%h3#m5Pr^8(cifJVspx1^SHdG zdLTc|s?n%;#zqgvy-I1>o|kH?NV#zPalRfy)45Ez=mW$?mZsWNeo{Yq&CmCG$xod} zWH_b-mw6E@=<=ZD&3&%A_zk~=9(RGM_}(H7^)&B~PPU3Ml&l#S*M(z=8qoZG|1-+Q zU(j0guWxBIDzK)fq2HFyZ3#K#nOwuSa#Hp}Q4{c>`S5Tl>=0zht$xpC_ei(1aeaOI zXGJQvmQTDw?w4LgW?ZHN%Hf-R*k!Ft*C9lzhz=X|rcC_KOO|CrOfp*#ZPLucb3x21 z^;@folY-clPjaBkZwKD94ncDW4KOt0m9gQiYQ<9hk{9;|9d6ClkS7BS4C3Y~IqR&H z3ZOjW93uk7Jk1W6TV|b4GF;9*Xn1(s)wq-3M$!E7VVR8ub`&FZJ4;hRdVH@QBL1wa2phPA03Z;oYC zJFK%S5U6wG&ow$VA3fVP8R+YO%lGTF%1`Ne0+c`s0r-K(GA|xIv7q(7`+C7BQS3>x zV@FLCX z)#IpLns^6aaElABbQvP^{fjonOL0Yo!Z4_cG{kBZwHHkjAYNoxnp zo5u*-$SE|`G(NrV`kghNl#zE4hBxr*(4iq~)*p=3sUmUpg$yf9KTf?*>Mh!P$^E-dA+oVgBXvhy3V>u30)uQTT$T@H(VnGA%pLQ0dRJLrKO&|_k&6F zhnLk4VurdeDURS$XV0H5Z%z^Ml;=FSJ1#JwGn8Q*8fvi-e(#x$CvjZfNBGq!m5+1e z?QO9(Cc`s3e#~nS^*vRi41O_jzgulM1`W+TJHdBe*=j#o?~&}CLJBl{#mJ`S z@|d>^Pfl8yPnSep=ZLceiN=BbC#Ch-)>H=;qakntoa_BH-*5ud8Wg1cFYo5fa>wkZ zOLlTeYE<~tQaUY0gQ{cXb3IC@8I{n?LK9}A_YdQSJ^seyByi-IV24=ay|~KQ%-qxK zJs~>Tm09{&J6rZAGs5~XwSDEhF7skrjj~a@qq+;u-!<9dOd`0xOOFHvuxXj7^|zhJ zZyhVju3gT3Ehl@Z$PL&=PMTrj3hr>7OMDL-J==0B0oy9|1zFRz?EA%n9x3GzdFR$r?!`^ep;`esS^huWy;sk^;% ks;zDQ#+6Sc-M68H3JFHEK?X;w@2SFn^%neBoOCkwAC}-h1ONa4 diff --git a/doc/src/Eqs/angle_cosine_periodic.tex b/doc/src/Eqs/angle_cosine_periodic.tex deleted file mode 100644 index 69aa1bba6a..0000000000 --- a/doc/src/Eqs/angle_cosine_periodic.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentstyle[12pt]{article} - -\begin{document} - -$$ -E=C\left[ 1-B(-1)^ncos\left( n\theta\right) \right] -$$ - -\end{document} diff --git a/doc/src/angle_cosine_periodic.rst b/doc/src/angle_cosine_periodic.rst index 43e5c0a4bf..caaf15007a 100644 --- a/doc/src/angle_cosine_periodic.rst +++ b/doc/src/angle_cosine_periodic.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style cosine/periodic +.. index:: angle_style cosine/periodic -angle\_style cosine/periodic command -==================================== +angle_style cosine/periodic command +=================================== -angle\_style cosine/periodic/omp command -======================================== +angle_style cosine/periodic/omp command +======================================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/periodic @@ -18,24 +18,26 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/periodic - angle_coeff \* 75.0 1 6 + angle_coeff * 75.0 1 6 Description """"""""""" The *cosine/periodic* angle style uses the following potential, which is commonly used in the :doc:`DREIDING ` force field, -particularly for organometallic systems where *n* = 4 might be used -for an octahedral complex and *n* = 3 might be used for a trigonal +particularly for organometallic systems where :math:`n` = 4 might be used +for an octahedral complex and :math:`n` = 3 might be used for a trigonal center: -.. image:: Eqs/angle_cosine_periodic.jpg - :align: center +.. math:: -where C, B and n are coefficients defined for each angle type. + E = C \left[ 1 - B(-1)^n\cos\left( n\theta\right) \right] + + +where :math:`C`, :math:`B` and :math:`n` are coefficients defined for each angle type. See :ref:`(Mayo) ` for a description of the DREIDING force field @@ -44,13 +46,13 @@ The following coefficients must be defined for each angle type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* C (energy) -* B = 1 or -1 -* n = 1, 2, 3, 4, 5 or 6 for periodicity +* :math:`C` (energy) +* :math:`B` = 1 or -1 +* :math:`n` = 1, 2, 3, 4, 5 or 6 for periodicity -Note that the prefactor C is specified and not the overall force -constant K = C / n\^2. When B = 1, it leads to a minimum for the -linear geometry. When B = -1, it leads to a maximum for the linear +Note that the prefactor :math:`C` is specified and not the overall force +constant :math:`K = \frac{C}{n^2}`. When :math:`B = 1`, it leads to a minimum for the +linear geometry. When :math:`B = -1`, it leads to a maximum for the linear geometry. @@ -104,8 +106,3 @@ Related commands **(Mayo)** Mayo, Olfason, Goddard III, J Phys Chem, 94, 8897-8909 (1990). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_periodic.txt b/doc/txt/angle_cosine_periodic.txt deleted file mode 100644 index 039144797f..0000000000 --- a/doc/txt/angle_cosine_periodic.txt +++ /dev/null @@ -1,89 +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 - -angle_style cosine/periodic command :h3 -angle_style cosine/periodic/omp command :h3 - -[Syntax:] - -angle_style cosine/periodic :pre - -[Examples:] - -angle_style cosine/periodic -angle_coeff * 75.0 1 6 :pre - -[Description:] - -The {cosine/periodic} angle style uses the following potential, which -is commonly used in the "DREIDING"_Howto_bioFF.html force field, -particularly for organometallic systems where {n} = 4 might be used -for an octahedral complex and {n} = 3 might be used for a trigonal -center: - -:c,image(Eqs/angle_cosine_periodic.jpg) - -where C, B and n are coefficients defined for each angle type. - -See "(Mayo)"_#cosine-Mayo for a description of the DREIDING force field - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -C (energy) -B = 1 or -1 -n = 1, 2, 3, 4, 5 or 6 for periodicity :ul - -Note that the prefactor C is specified and not the overall force -constant K = C / n^2. When B = 1, it leads to a minimum for the -linear geometry. When B = -1, it leads to a maximum for the linear -geometry. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none - -:line - -:link(cosine-Mayo) -[(Mayo)] Mayo, Olfason, Goddard III, J Phys Chem, 94, 8897-8909 -(1990). From de166a3d168e1445f371ec71f203a4289f1d82f2 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 16:19:06 -0500 Subject: [PATCH 409/557] Update docs: angle_cosine_shift --- doc/src/Eqs/angle_cosine_shift.jpg | Bin 3933 -> 0 bytes doc/src/Eqs/angle_cosine_shift.tex | 9 ---- doc/src/angle_cosine_shift.rst | 36 +++++++------- doc/txt/angle_cosine_shift.txt | 73 ----------------------------- 4 files changed, 17 insertions(+), 101 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_shift.jpg delete mode 100644 doc/src/Eqs/angle_cosine_shift.tex delete mode 100644 doc/txt/angle_cosine_shift.txt diff --git a/doc/src/Eqs/angle_cosine_shift.jpg b/doc/src/Eqs/angle_cosine_shift.jpg deleted file mode 100644 index d9929939c8a3c9ebedb7ba50d8bf9ee84d5df564..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3933 zcmb`KcT5wGv%p)56s1_oo-GsC!+WS6C76+u7{1Qe8w2#5lLh$u2- zk0Qge${sRWhENKq%(6F+U*3DkOMZX7a7{Uxb12MuGi#-&ewT# z&c!R4et7Y``aD+FB=U;Z;J9hyhbw|pITQQttUD&&ma(?}d~hS^V}YM}$Hf6QKiiLI zS51?GJ;%T5l^0Hyv%2wH35g9d{lkvY65C$62BM2RNrL?w_$Z4^bOPzup3+YmYtj)|kui)BUaL!4k19H8r{@)h1 zl)t^l*%08bHpo^qm1Ta88K=s)hHlRXhXMQM6}@R)!uYt>OdCff-$bFJrEsnLe~p8+ zX!VXLPH*cdmdzrT^yoK(PLV2(9wg>h+^NdTt#w!uATk_UOGzdLUnSBHm(@M?M_Ht4 z0jue2sl01EW|dtArjhKJiHfaM$5x7*;- z<{s}c;U%_4V;IZ_Ehv|PZCiz{TfY;rL-;FP;FDXwmr|;)p!}5yD%snAp)4?L+8<8R zbmJ&%rzE`gd60hniHQT=BWZYPabN9`lb2CC?0ATeFX=m$j87w@Nt0fk;0tKc<`sj- zv1k|F&7MoTMdRZdX^QpEji6zanQQ9==bd`lnGkN1SdyJ&a@&j(tJk3v|6AA4G@J3G zzxpxd?Ov_L;JA*;o>s?qUWuCS-O@ErTXhW1Wq%6y^uVyy|kdJx|o!Y8A5iPDy3`k}vfgonPLjmZxZK415xX7pl< zkEj#X&d1C=g^sqAFoJkKgwHF>t;-dKWVC|@jXu=s=;+=}pk?@rCM63b^ihkZV%him zt>f0KZ3%8_=Q{a5WM(;CDKqoq-jZvI3)dFE>a5)jvt7%P0Pp2u7=yWkOB z&fu7mz1aa2{qk|YV$p$E$}gO#ZHsfFS9uv-ZMgbzWbp)G!}w5PQ2zvAsy%jm$qFfv zE|{gnk5mzSe%;Y^Q+J_zY=3f1K-6{ZoK=j!$o1D-4%KQ7PilkTsD=So2Q<_+8K3$> ziwP2fgk(qMPe|)3j~!$##4GiFc8*382k+p5#<8i;U_VezRVbwsDZ{n?&XWVxTQ5sZ zm!KE&Y(yTBmKB}`559xMzwGnRg)f8^?T8xQzbHVAzi+4!-fmwrb&D7G!u9RBwFbp5 zQJW)#sUBrJKI+kmDn;L~bXIwOW_L=SZPIrjpUa`-rd(L#ktDb5K#_Qw<6MAU(IyFH z<#+JXPByR9j_TXk=XLz^?Y3|^BHh+)-eqf8AR_Vv5MZaHOATS<*2nw$&>@Kl(gC->ygMP12L(f7ocwf;$?#} zYB5!-ynzeCUmVS|Ky5`wf`4Q2kZwCSCOhSXO2!~J*il+?wL5@&H3MHz3kM|tD`&)a)KRGi9D z_}qfSZ)UHq{f$pN0eJKQjxL% z9Mt7JUm9Cc?}`75h|kDs=bm|8`bK3o?@iyY2$q;MEyeOYRbR>u^DNY#=#V>AzDFtz zFycNGp&mXWA~^K!mh;ZBt2a^J;ghC5*4at7WUYAr@*(geH&A3w&s6iuSbLd=8NU4B zFXGcRXmBz%5d7SFwN-GgLvW%J5+OJ2l0+zpdzs*bk3{HSw{Y^`iJ_=%R{9~B#R<3{ zwg^|TJ;WnxE=eg>ql!Neh>SRWYPcFj#B?anEvXNpVGocaH;DN};T019lU`heHMFKe z#;;>zTSb$kmgKThSwz6Tpb6j$50FGuCrRs2m9iYdQiw!SYp$U-pea!oJB$Ps-RKZj z_dD(Z=k3d#+x+W8`t5&fLXGa0)Z)Ocd!U+MLa86EBVN&-SO1Jv!poKFkn*KKWCjVn zn8=LvfnT^sW%XY@cP6K>e6wp}Mj+w5%nq71$<5w?Q*yyA@d`RoWr&=bJ= zt)p|pbgL>!YPX{ISO(_shia~g&d7um>F6T>fBp*N9)T_W)Ynm>cK5GBY66q z(9G|+uM2F3MQ)4v`9D{mR2pt6B^@n2)a;~&UM<<3l3BTwk!VK?ys;UdTxb-c+8xC7 z^fv?Z2TuaW1joeA$kXiocOA#uD(~m;nmI;a>JwJ6>Br_A`<(v?H&?ku- z_i=G2C1K4p!Fgc~_pFCUm3B8>9G*Q-*PJg>=ZA!jS)j^UW*xdXI*iNu(?i)4K+gauTV9t>O(oA~ITM_3=AF(t%^Z1&! zba~rpB>QD?A(1XzXP~u9Z1nj^=U*Lckf+!Fd70O?W;I&QN1DEmk6SIqMiTrMMZP1lCf|CixKbe;&U}UF|PwSfB<6ZZxjeg(h zmgVcYO(J@ZzQ}lwf;es6skRdw%NrA=$lb*rcs!!6PO`$(N>L-A+%`WPQ8MGk&&`f1i{ zKQGOHKO``z)w~p&SI4BU$I=0xwkcznAGTWE(wdi7TcWhCs~P)m#ak9%BOY39r%V|0 z#IO-v>Qk0<1^YXHkVKPmdV;PEFv444E0%qmflZpU5cw0p%ZL*|XXbNiz1>-lk+pg+ zXzaIn-bv}}azEAwwWVcn+9OS>hYU6UI;?f0X;o#GP#FHuc(ay~*8o3w@0|#yK*CNU zz%9~%f|(T#(z+Z@)%OO1HHh+-8L|nMp^yaPRW55A^?2-5lSGwWynL_=3E8tpI0I! z99VntT2(iY^W%>G+*bt;Xp*C~K#?{{s(Y-MP{ap?Z{``cYKZ91lGNXKb1m3sSl#Xk z0L7g)D}ZIWw`a#7Pd-s{BHHeJ>&G~U=kn4UZP=71uP*HJ1u}s;^5yMGrlnjxAg!-Ewc`%jQI(H(4?P3oL=pHbF8i?@iR)`x$U ztGEdA$Q7{QTTnhG>NRaWd0!`Yt!= zr@qQ%LG7hpz+oAe{uFr&XjJ(%5T|(-qNaGfWq_W;4TyFW)wP;8-oITcLDo$TG>#t) O4JZH4r2jE` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* umin (energy) -* theta (angle) +* :math:`U_{\text{min}}` (energy) +* :math:`\theta` (angle) ---------- @@ -83,8 +86,3 @@ Related commands :doc:`angle\_cosine\_shift\_exp ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_shift.txt b/doc/txt/angle_cosine_shift.txt deleted file mode 100644 index 65dc0924e5..0000000000 --- a/doc/txt/angle_cosine_shift.txt +++ /dev/null @@ -1,73 +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 - -angle_style cosine/shift command :h3 -angle_style cosine/shift/omp command :h3 - -[Syntax:] - -angle_style cosine/shift :pre - -[Examples:] - -angle_style cosine/shift -angle_coeff * 10.0 45.0 :pre - -[Description:] - -The {cosine/shift} angle style uses the potential - -:c,image(Eqs/angle_cosine_shift.jpg) - -where theta0 is the equilibrium angle. The potential is bounded -between -Umin and zero. In the neighborhood of the minimum E=- Umin + -Umin/4(theta-theta0)^2 hence the spring constant is umin/2. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -umin (energy) -theta (angle) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER-MISC package. - -[Related commands:] - -"angle_coeff"_angle_coeff.html, -"angle_cosine_shift_exp"_angle_cosine_shift_exp.html - -[Default:] none From f2271e294df2e36abba13fb04a6755fb3b2ec06f Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 16:32:17 -0500 Subject: [PATCH 410/557] Update docs: angle_cosine_shift_exp --- doc/src/Eqs/angle_cosine_shift_exp.jpg | Bin 7884 -> 0 bytes doc/src/Eqs/angle_cosine_shift_exp.tex | 13 ---- doc/src/angle_cosine_shift_exp.rst | 48 +++++++------- doc/txt/angle_cosine_shift_exp.txt | 87 ------------------------- 4 files changed, 22 insertions(+), 126 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_shift_exp.jpg delete mode 100644 doc/src/Eqs/angle_cosine_shift_exp.tex delete mode 100644 doc/txt/angle_cosine_shift_exp.txt diff --git a/doc/src/Eqs/angle_cosine_shift_exp.jpg b/doc/src/Eqs/angle_cosine_shift_exp.jpg deleted file mode 100644 index 294986de4b66d52f010331b7dd43b72d8d7b64ae..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 7884 zcmd6sRZ!f^x9@*AY%Bx82L=rZ0TOJm0Yb14EQ(8z!3K93dF2q(L4)jj{GTj%N4`E*r3bg!zls=KS#s`b5@zF7utJyq9K2Z)G>fG2+j za5D#}0AwVjq@*Ndes`_`zHduA6TFH6;Ki9ws6J0XOXc7$5?ON&fZme<33$A*CQDqWrU~c?%#S zB_<*!A*CcHrl!+94cNF%?=ZugP=4^~rKk4oq9Sw% z(~WXzcqtu8P%EjAkr*t4Ht`*g2!c_AS#}>ik8|uZ!^q~joaZByhxeaMQ;)0})?W0< zGSyk=fzP1o&F%0~5qDxG&jW8I=Pld%7&rFq-O4wWGP?^7PSzihs7O0y37fY^nzvDt zvjiB0lKoik{%mVatvIx9L4?$Kc6i(6T7AvI zsLUsmMM%46XNUtHtIt`z>o)DCbW52Gp_TlZ&JnCS=%p{L3NJO6oT=Aqp3HfdF8Sn= z6SXzFsQN#{oOFaOi!wP{Np4OZ0Z3b^tw@?bwFc%6Q>&TSF#=wo)$p0=jw#yw^SADT7!oa{Fq6?eL4-(6an zs(iL)KhmzB?qE~go$o!fbPrUSA2!SvHnch7Mn_t=M0o&Y58-8-9TGed*Y5```ntDt z8$Xdo-i?U=Mrmnzg`>a4VXH)Obh6vQFQ}B>)s}#2Q@?v)V0wYp_&#Kqlq6Mq}|JbU=Vh zBBozoaPF>$ut`za_5pO>d(Hj^5W2VSdMIFy0eQBt$g+s6;{2|rd+^UzT|Hp7Q1e;~ z{)5;+8k% zR3FM~{EM;4g(&wdi`%FKQ%qZHEasTvb=KH`!vSgp!;iM6B5f(@SWr7aXzoK@iu5Gn za#OpSBcC?dm2QY#^W$($XnO0}Wo1Mp&~P^zT%43su<_gB<2NI8%3srQ~( znyUXbSbK#mj9F@J_B1+Uol<@y{i#&~47nYO)UrWvmZ5R750m}5%kJ4DCZt<#I>z@ljk zgpe=bMRH}PXb}`fsV}jZoT7_EdCn}a@@P19UB(0!q42g07Q`CojI;UZ?za%Lx|GNY z92As|mkOHAuyUIC>LkB9X1RI-znqC*$<*yo@BU6&d29lDa^|`q`sTy(sKzHcpJuy> zH$VG2l&&+{lx7>0eh1V^2l0IZyyr=(2NV;Q7SSBP1HUT~rt7W#UvELE@LgRW(z*?K zz+V`^j$PT(a*{KIjqq4gfp$JO&F^EHu3l-7|L&G8WsK;D*C~o8U!ho?`pi;MUj=(u z{ol+t$St;DUMh0Tto<17ZR;(0R_F5Zh2!CnZsmKM1WCzq9E-f}zVAG$=qWF+=*t!9 zyM)_F>+e_h(Qx;pj%;`l^VOAq^7wN2!+jtA}{oDKIaq9^N^AB6SUQ6&{JJMw_t zdaQENIMWtYo#M)2%%|N1+Hmid$AxaMkCXA3j@0fpOubTmHhc46R|vVcyu}VvWAukh z#lNC>I-#f|K2^^STPiDG?F1c;wpC1&DuvWHuH}gNTgu$4pTiI?Dy}@(CLFGAyKFDm z&`EUiU4*qYyV(bg=cJ)eNQr$P{-1Ocn>AE>8#ZWc$I~M*zB5`wwmq>`-@wKhZ8ibU z@Y40?nUxb2+1o6hPEQ>D(0k_LbNoUQ>ty7lgPBwOTeVZVrqDK?@O1=qn-o`PctkAZ z)G-WuwMv6Em&mbq9+G(caOhA@{$Qi|22kk!@tS{~(Vf6K7oOzH55#-N2Tm`JTi6BM){Yg!K4~cr9zQCGzmS_8fOF8W#rhL%7_=Kswr+tfG`!D0F|K= zltRU`7*L&-)GeWQuoQ|e(aRM50Cp+RCg8qZ49;K5PYmSlRL#y(y2kg3!zHF-hJAJX z9N@Pk!-yMP`Hqz?<|#cGuvj%!7d&ml49wt!B*WtSY|aYYtf}k;wK*R6#PAe*{Q2Jf z${5o3?d}Ut98Kg{?d=FIy4gR#s+6{^sHlgs|0xb$QNyM%W35Mu7T5(DS!S0kX3H!N z`b6WgdS21s`m3Yyu7;K;=V@bepS|H^Lv;#Vob4Xqc<=nYdJASuulCk< zm;JB7-gWC4Y~9GtSK{))10FJc{f~0CH95GJ73pGTcbCcVAkb|MsWroWf%b~b4B>Mq z8d|xlGYZ`xN1aq5O?5-Bx?ek$Jsfgxz8}9npWO@~{PQ%TKlM!a3}5y`tNN~W z_F|J*_QA`jg|T{K0x~h>B8@_>$4aJ*xZ{}SwK6qrnkR4K_vBrAg-7^noe_wav&Er> zNzhBv4TWeMEnj(uQ&!^@z53Auzfei&qs5xsCQ9?b)VgOY|;FuU{sH^`QDAd)}pDr+FWS<0mZO}qj z>3Qr*U%SCyP2)D*yYgibCv!gBrNwA&yl_4&Iy{^Ge8#B*2ES6fuV|N%QoHRPV1g$= zsq7Rict%KmU7aWjsewRDFT-t0JWQl7#j@2`7GPCJ&nO(?Bc*YQZK1ygF}v;#ikL`* z+R$QEX5?8&&YDa%UEkKkKdl_cGnBJk3YEQbA4*sQO&3lA58Nq~`vK=Uwkxi+Guikk zzxiuCq^kFFr+;&9bgG$Z?d=eWopPu6p3{!wZ1fk?^CY8=wZlvVE!bnDa;z!2vGuEd zIP_EpzPiFnNz}lp8%W;S!+s^0V1^&6bERu=K1b6gIjK3Si&e%;tJ z{Gl{q6@tva*x>GiKd7(Xr|ouoPTALy@#8ttg*$ARl-b5-uxEe4N8ws}NXF)c2c$ql zdQBX^IM9i|eJBOisNWd49=iugoioC2z|Ks;!t21ShWbCE&T*=Pd{>gV))zeQ`QN_Wi-@!JkPWf_*%m{n zy#bQPMo#0ZAseoNTW9|3lU33aW9N}IOE2#>4sgI@j$~@3_Cy3qMdXxt-|gi@Avsul zMS2|99d+bA)oD(x{nM%_>1K56Vq~+BN?QZ7 z<3-ERMZb@e5|cWOS$*<)+9)MNUXUS@g~52#%3+H$Oq6fDG$FcnW8~*O3D`jgSD+;t zVt7mv`^i)RF=B@WFC}=sYsm;Ky1uqJqGvOxTP|f1%=IV~(wZ+q_a%0w&7fkFGnN<2%u z0-B@1A>pz-oQP=QB}o(KImv`ZP)Xs%NSo3`*$rT3;kWS7>>vGVF5{186_OaAGQDJJ z59lIRy_qxS#CSeK4ATy+>pIdN;ucTwjzd!o_UW=Z2FeYz5NC6z5%E% zbGGqH&8FvDCYWAZ#doHI4i^Ly5_wwvOBQ(X7FVky@kWHX1IJit?uX?-uGvY#@051U z6DI;)TvXKSzpHAR&tc~8K3kIxbm=>1m%$#l3O=9N9$vfw(mz=pT?Hn1xainM-K}v{ zH-aOQ@0xjWb;X>7iZQqML(4ex> ztJioK5J0<}&b>(>KansO&Do-kLF=S$yPIGiD-sqT3~Ck{;~#9 z2O(r@&si^NO06LZw7tPa&2lD1{I04Ei`)){%_p=Qp!6Q|`q?u-v@07MX$Et_$IZ@W z_E_HryQ^fqqZ8SgFmRL=NtvvtZeG;AMb3R7J3%eb=3Ak?mB&Pz-^K&EE)dx{T=+Um2%RcJ6w za(ai3jU8|X>$i|2G+zG0#c3>Zq7j}C4bnVjs|XPfOzwmUcYA;#Bj-vhm33qRy8S~5 zYYbC~>;i%LUT7z6x*dpram;&!${W$jWeS$+HYEEhIN*o*T=f=}Nc9ciU)j4Vj8aNP zq9Hv`H)KWaI1_ONdh~UoR?OrlbA^fuc+GOE;q-CWU0w97d_)O~DepgWL`mx9di7&! ziLvasiq5I#s`bbxnjFIJ)|sOkxm)fKUIUJf(LoQT{2^%XXs=p4*po$t)@XE$F^Xzt z@5QFKw1%xhPW14_-5Y@7had-*5X@uyF-1U0c1$C9gDj6A(hsQZUB%Q zxcxZOMlha3gG1-Su7~x<%<#rjwaAo4Nguv^dNW@WWM0gVU`;e@(L4bKMh+40xTo5+ zNk#j}tuQFI{gli2dMfGUZ2rNT7ll{t#K#epAk-rsodC#`d{xy~=SQZc63KASc?&`H znkn5_?YCOhoWd^YP|EfZoI*jVFoJ#AhhF8$mi&At3AF$R)We8lup2Hy{?*|ptaiHd z;CTnvkO~q1W{OPWLYInZpxD!rCoq$>%BjlWuTap_WQVUtwmS&__?*69A2l@L_^6%o zc$G)@9FvB?N7CVzaJ(bpw0ul6vGJT`C=sVZBVwJYyGHAqc0VeQgX0O{V6$RdfDT+C z)!#RV+posP?JZ`WJsyLd@k1tl&{i^fL5=7eX7XMmVJ_{5OVlMM@Yoqxw$6;dt=pZa z6Iyr5@3seXn%g{sf_BFD=sJQU9R%Jd7(Y2tB0B|v>3y0SI2=YO@WAKWYGv53 zcSmq@@9}TciH>*LZ7>U`GkFsRjWELVAE2Dg_W4eE+LU0?Cna@}8VU&=JU*$W!0);D zP(9}?#$1O#?L4&?Lx-lp7VW_b1NnGi=;6e!!Nc;vuW5ps_94OF(XJ-y@r}OQ#HZ~t zYIIV)m+HXvhAw! z4X0cIrkk6qLCT`pvYJ-V66tN-n~(avjXt+&PS+@XVKd{%-%cFl2wr7(1L)uBb#&I+ z`ZBHPx~3Ygd5K6!G5I;av=tdSsc3+MykPx%oV{8xbc+q-R}b#SCdaP$56U70SeW~* z-*noD_65$AJwtXDk7j=k0QVS;cfslw1ZzcovPy`oR;T@rZt0pi2G)o?wXJsakXsK9 z<&3he0swn<0IA78d1X>0EahfeN}0u1JNP<{D!sLaeGvUb_?DuAnD+V3_+JR9gP_8NE;($_>Fawo?aW zSYPSh0Ax+Qeq+aV{dWRT-JjPE4>DEwC;CU4W%IT$XnRjR57xaXx?KqI<6_T6YQZ!1 z4OS{?2>wwBob;>GFQ@fN&i;2br#)*pM+qWr?bJ^ zn7_n3#<(HwotnmjDfS0NHTB+h8*Z5gk}H`3%-$8rBN@#H&%w{C_x^??=E$dN^s5Q> zn2mry8Xj?XZu`r zIoq=er_itgq)t)_bCtK)+iSk1DVNYEFEjH7)G-)ZXiw zE$Rm?u0yLIByCpx`_1N)8nyVMa_MwE9c@iI)6Bs8fTB9?$zZwn#OQTa;sMb|R1010 zTRO(hjHm+GWIop4dA>%maZVrZj>NV+qQwSLya$lC4P?Wnn?pKeqg~I1c{|yEb^QkG z$LXR~E~%DdT2eAv9(l_S;Ej-ze|0`!OfE#7eX9IX!f3?J{FtJV(6BgR7T}G$C(~NS>y)1fKa(tyWpThmUMhIUT z#gvX+_+U!pWC!s89$jSD<*{Ef1pn1t)Xd{f<0|z{f(3(hJT|Cin$=(C)_KvdyN$MG zA(jif45#Er>Ibm)&y~E&kV-3ZdOergo0Mg$uwKxlHy=L@WD(^yU!O=(b=9iv-;1q| zSYhkEn1@vkC^-JGzB+#)-q^JF_8;{siO++c#)Jm7g`bh>c*{n)cPO+xgt1Q(9YOJQ zL76r>DEI3?3=ig5r%*EGRMo6pqwzQhI;QY;b>K6m4=&EkR~INWoma8Be4KZ@>VROK zJeAp5^yja|ng#)Yil0!A`#gIMV;$Z%F6WB?#l%QE5UzZw2)TCyTt}ahS+@DPlfld% z5V>;qA$>tkvjy=?^;B+2J=C@#MhsA1W&16cK33iC1Ei{&Zns+l{g9mpYvUXq??L%K zo_BiZRA+)iJIJkX99F~HXHqeRcn`{}Hb0W5G60a!%DB%=FnW%`_L=D+AGzcuWBWgX zNuKc*E0toFiQst2AS279xx^1TJ#`<$_7*mDSBI6Lw}#|MeLI%C*2niraww*GpKttD z&Bd;u*h;f6Rw`%SaQnHXP|u&z?rvZ~h4MueBTYzRUV@{(q}g?{E`@ub0x%rcogM&X^}P6{k7){V?8pnv}Dz-zO1dl&1n#bU@gA%^(D+Man+x( z(D|>KPufHUH-Mp~^T?9^>DV4fqHOq}Fkr9A>0Uwq)nC7VU1a?ZoVfv#KK)0(`4;5} z2N}X@^Ht}w*te9bOqQf-jG9}hh9xcE&5-nfM z=0=wAvvkrwLxk?`F?ctfoXQ(-%g_8Vvf#H51b49j%gS5s6qlfRVbf{C` z)B)D0h)RtcU$E_Usb z>YvuQIxUH$;8z^b9GZkaKGqp_6>Go1fK*eu*`WO_pP6c__ciA4op+jN;DZm4;SW2* z^%f8sc^dC$1PPimCicthm9ZDb@QKfY;no;D`+KQsbM0)6P<(cp_emWUjLrN|8~@FX8sFayEYa8 diff --git a/doc/src/Eqs/angle_cosine_shift_exp.tex b/doc/src/Eqs/angle_cosine_shift_exp.tex deleted file mode 100644 index 4afa01356c..0000000000 --- a/doc/src/Eqs/angle_cosine_shift_exp.tex +++ /dev/null @@ -1,13 +0,0 @@ -\documentstyle[12pt]{article} - -\begin{document} - -$$ -E=-U_{min} -\frac{e^{-a U(\theta,\theta_0)}-1}{e^a-1} -\quad\mbox{with}\quad -U(\theta,\theta_0) -=-0.5 \left(1+\cos(\theta-\theta_0) \right) -$$ - -\end{document} diff --git a/doc/src/angle_cosine_shift_exp.rst b/doc/src/angle_cosine_shift_exp.rst index b4af85352d..331ccb9da7 100644 --- a/doc/src/angle_cosine_shift_exp.rst +++ b/doc/src/angle_cosine_shift_exp.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style cosine/shift/exp +.. index:: angle_style cosine/shift/exp -angle\_style cosine/shift/exp command -===================================== +angle_style cosine/shift/exp command +==================================== -angle\_style cosine/shift/exp/omp command -========================================= +angle_style cosine/shift/exp/omp command +======================================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/shift/exp @@ -18,32 +18,33 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cosine/shift/exp - angle_coeff \* 10.0 45.0 2.0 + angle_coeff * 10.0 45.0 2.0 Description """"""""""" The *cosine/shift/exp* angle style uses the potential -.. image:: Eqs/angle_cosine_shift_exp.jpg - :align: center +.. math:: -where Umin, theta, and a are defined for each angle type. + E = -U_{\text{min}} \frac{e^{-a U(\theta,\theta_0)}-1}{e^a-1} \quad \text{with} \quad U(\theta,\theta_0) = -0.5 \left(1+\cos(\theta-\theta_0) \right) -The potential is bounded between [-Umin:0] and the minimum is -located at the angle theta0. The a parameter can be both positive or +where :math:`U_{\text{min}}`, :math:`\theta`, and :math:`a` are defined for each angle type. + +The potential is bounded between :math:`[-U_{\text{min}}, 0]` and the minimum is +located at the angle :math:`\theta_0`. The a parameter can be both positive or negative and is used to control the spring constant at the equilibrium. -The spring constant is given by k = A exp(A) Umin / [2 (Exp(a)-1)]. -For a > 3, k/Umin = a/2 to better than 5% relative error. For negative -values of the a parameter, the spring constant is essentially zero, +The spring constant is given by :math:`k = A \exp(A) U_{\text{min}} / [2 (\exp(a)-1)]`. +For :math:`a > 3`, :math:`\frac{k}{U_{\text{min}}} = \frac{a}{2}` to better than 5% relative error. For negative +values of the :math:`a` parameter, the spring constant is essentially zero, and anharmonic terms takes over. The potential is furthermore well -behaved in the limit a -> 0, where it has been implemented to linear -order in a for a < 0.001. In this limit the potential reduces to the +behaved in the limit :math:`a \rightarrow 0`, where it has been implemented to linear +order in :math:`a` for :math:`a < 0.001`. In this limit the potential reduces to the cosineshifted potential. The following coefficients must be defined for each angle type via the @@ -51,9 +52,9 @@ The following coefficients must be defined for each angle type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* umin (energy) -* theta (angle) -* A (real number) +* :math:`U_min` (energy) +* :math:`\theta` (angle) +* :math:`A` (real number) ---------- @@ -97,8 +98,3 @@ Related commands :doc:`dihedral\_cosine\_shift\_exp ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_shift_exp.txt b/doc/txt/angle_cosine_shift_exp.txt deleted file mode 100644 index 3091e83885..0000000000 --- a/doc/txt/angle_cosine_shift_exp.txt +++ /dev/null @@ -1,87 +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 - -angle_style cosine/shift/exp command :h3 -angle_style cosine/shift/exp/omp command :h3 - -[Syntax:] - -angle_style cosine/shift/exp :pre - -[Examples:] - -angle_style cosine/shift/exp -angle_coeff * 10.0 45.0 2.0 :pre - -[Description:] - -The {cosine/shift/exp} angle style uses the potential - -:c,image(Eqs/angle_cosine_shift_exp.jpg) - -where Umin, theta, and a are defined for each angle type. - -The potential is bounded between \[-Umin:0\] and the minimum is -located at the angle theta0. The a parameter can be both positive or -negative and is used to control the spring constant at the -equilibrium. - -The spring constant is given by k = A exp(A) Umin / \[2 (Exp(a)-1)\]. -For a > 3, k/Umin = a/2 to better than 5% relative error. For negative -values of the a parameter, the spring constant is essentially zero, -and anharmonic terms takes over. The potential is furthermore well -behaved in the limit a -> 0, where it has been implemented to linear -order in a for a < 0.001. In this limit the potential reduces to the -cosineshifted potential. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -umin (energy) -theta (angle) -A (real number) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER-MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html, -"angle_cosine_shift"_angle_cosine_shift.html, -"dihedral_cosine_shift_exp"_dihedral_cosine_shift_exp.html - -[Default:] none From 579b1271b04b5d88c90c42c1e136dc4cdb3e3047 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 16:51:06 -0500 Subject: [PATCH 411/557] Update docs: angle_cosine_squared --- doc/src/Eqs/angle_cosine_squared.jpg | Bin 3265 -> 0 bytes doc/src/Eqs/angle_cosine_squared.tex | 9 ---- doc/src/angle_cosine_squared.rst | 37 ++++++------- doc/txt/angle_cosine_squared.txt | 75 --------------------------- 4 files changed, 17 insertions(+), 104 deletions(-) delete mode 100644 doc/src/Eqs/angle_cosine_squared.jpg delete mode 100644 doc/src/Eqs/angle_cosine_squared.tex delete mode 100644 doc/txt/angle_cosine_squared.txt diff --git a/doc/src/Eqs/angle_cosine_squared.jpg b/doc/src/Eqs/angle_cosine_squared.jpg deleted file mode 100644 index b992398b7d0cdd42707f3442eaa2dcf1896e0dc2..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3265 zcmbuB>pv5W`^PuTAvq@NM&xXSk|@hL*+yYz7*P)0&Z4O4mP6#mEi*F-EwwpsB<8GI zXxCXxl00Myk*lz=l zSO7}^h?kF#j~DbiKp+smz;Qu=-x3oR7CJ5=CMhW)CLwV`S`K_dO6H`5#3{v7GN(@~ zC@7o&E2${StH{YK$RB+G2nzyifoFg~3BXY+Kn?%|@bK^g0sk)$Kc4`QSCHrT)L0w< zp!|e0uYi+I)8Eh16vu25RhBm(xdIGu)Mj8wVop{s<@2vYY|q%bz%N zj=_>E(%<6L;Qw&_9seRGsGA4KB_ludm2?~T+vY;*Z+?F^dJKuC`{X>P zmvHw&<@3@qEJy!4HdLOPk|7XYTr8oeXK56Hd{u7PuItRoy_@SdM(rt;Axk1i1Uxj^ z`h#T*j-*n7+x&5*VP#j(weye9+UGOwHqp)#XKfx<4@MfcY7Zq87vbX&W^m0jJN>Au z-mU}p&Iw|_wCF;SSQ@8mzxgzMkbK3l{k9c_Vr4l8K|k9R>CBeJl8pwE!)nM7VK~#? z#9V;mJoLMrtgm4?(i5Q>ck>nNzAEb%k+5z4+68B_G)S=kwaW8a346_1W#!+z#EFl- zz9|-;4HCcf!0@m#-2otarEYh&V|eu@>UyqaR<6ucs6@K@pD)kU-i2mZkmb$tYoAeeJgILv3c+G z;=zVWC5%o#c+FCadXX;@N?92|xR_0GeW8%y1CPU@9w(5}tkDK;0^f5%W(-FZpDnNJ zo(|M8{!)|nUA3C*S1k2XCFse>*C+V0LIbP0E?il|3ryZ#$G}0=OseAKuYB61>27@p zb(4avcvCNb9W1t_i`G6>W=LPHO|BITbo!uI*DoW+yC6|^IOooophMW$0!L2UpS?954pf!-AAp>bwR-9SvWa?G>(kX?L9 zE5*gORRwqKpPdCy&t5d9pA>M}FJHHaX_1TNu-C7V5x0rmsZnRmCnA8#TdMC(K8^2e zI6hyo(>oZ3&V#d9j-W`ULrCP`aZ|J5IcNskGabpg2OlAjW3P1xQ%M;7XbxlX2w+D0 z!)G3>dah_3>d;4p{B#b(iqOUKgAp+Hv!}gnuGtr$HF?pU8LmyxyF?b);8wfHJK!-y zN}jM|UW&b$tfKq-tE-<4)Co85kJ!9I0>|%3{O~yK3SE3kgdA>Uk-v_T#JZl%(I2s5 zugM$%d^^L6iM>tNvO_eGsf+XO7K4c;nwtp{uSoZr_l7;MzNYEI-r6t4b4&xh+_TbW zqd7@8owqQ9G1NfObl(xwtZRkSoOihTr>1e=FIPXFCo;6xcwYF*AmjRxtfZ)Ql-(Ei zmVYBV!&-Wo|32#WciWgXzPJf75hQG+e|xfd|KUaTKJ|$Qa^Qsa(4W%CR<*eRZX5?+X$a})fXKqS^Of5dtrM`5#8w*MKMfvGhGwBUw;4Hq3Se= z_4a+c;||+8-KTOq_nBw#gXh%xF}FU|T16p`xEWNunb8^Ul4kv&ZI=^Cz3m4}Icy}l zQ{kZ=Cl)p6viv5u7Xmp`97m==Zwyw%@Mo?E(sfOC=B-XHtZ{GVI9qw}!h%k!lv87I zRVW&SxmmQi@z&+s>TX`k^Ebx9=s}b3wQK0|xy(;hZY!#Z#@*43e9!M>S7IxAK@toGESWZO`10^`R{$>pwQtxYb+gQ0X+^+~Z{n0)pqS>TM){na|T)neP zH5_DSbHzqWzYg%tB5&I?UFK;`zG3Uzvz(oec)giLBS4iedw*AzMHJkx!C$Po474$22RypcrWbgyG-)u9ZC%}#@Dl#_7DcbWXgBBz zf=GhM2(2wbO*jD`Q&>fqAX|(2n|Y14h`g}HR6hfE%~ zT)dha6Wm_+y^Y6bHHCXS}e!?rP6_eypQ{(S0P z;jZSIA5oSW?|8gmM zZ6lS(3B#mQh^VCP2lZa@p5q)uon83ZcmtW}#?&5z*QVKcGgFIzgMj)uM@2@upq5n7Y{GqLa3x?&!;OO?whOfD9p zQ(4_mEdnAFG)_!ojQYksjGy}KtW(&ahSOahHkroZ9cNTI1VfO+OUoct8^9%U@rCAZ z5GxOhzmm^}77>ecqUX5*pJm#<*V>rJ8OR!wg+j61#_a|A;^&UfU9h(XNh z@hFtkj~OY{i8f6S`u)J5uE!@!hnKU52Vv)!I+v(nme&iQ>fZng6HX>cW*MQ2z62ZJ zAo%m_5MBNE|BlUFsXqq)6~8FpsYI)$1g;c%fg!tviZ5Nn$5UVGZzfz83gK_9tCF2s zLcW>0l&=aO6;ct0v0Do*gR*m(I?SzMmgaze9n0hC4{R`GOM7tbm|bunOi-@57jK;= zc5z2~e@p@P;$sZ2%?L4AsV|kp#)vx=Ho|cQ-3kwZn_4)B)XX(X~u(P z!-gdf(+g@n-?7@;!nj*Z`xz=u-Z3yNJkRbV>|Q(pCz)0Nkc_M;<_=(L7UVrg(@T*a z$RmIx*lqTiM&=jY*T_Ae$BByCYa{f`Qr3Z4qw$@^=ozk}`f8dR_+vFU1ctm+P`w}S zn1Zk#OriZr4;}5T8ae{V^GO6Ud_FOulL5yvjsVo4uK%Jay7G9`;y)iUg0mu%OeFAo zYftW?y3>AohV@IoUSe#G_bEcQe+>}{6f3vo;@Zig@q!k&JJUs~*Ji7;`*|!&Oc@AC z$pVhNhVoS{0@ccA80A?|8%o%{-h2aOb4&d|mAAv+dYX@m8!3*8P9CTJhkt2u7IGH3 zVGxXzAQELDXv+U4EY<8S#vvd8F_|Psutc<%5MvTwSIh{l1AjbBcv5xjpL{der?;ag zNW^7OrW!)kqyzu$_CiK`YO0SGof0J;iHtUPSw<@)p|6bpqUK%s(9WaTE~R6 z5$L)r_*3XGSZhMr;lQ??mUBn;{%7h>zsS!kI8vhO!c-|-q+tw)07NuvgscDQy@` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) -* theta0 (degrees) +* :math:`K` (energy) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians internally. @@ -85,8 +87,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cosine_squared.txt b/doc/txt/angle_cosine_squared.txt deleted file mode 100644 index 07fcb1ceb4..0000000000 --- a/doc/txt/angle_cosine_squared.txt +++ /dev/null @@ -1,75 +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 - -angle_style cosine/squared command :h3 -angle_style cosine/squared/omp command :h3 - -[Syntax:] - -angle_style cosine/squared :pre - -[Examples:] - -angle_style cosine/squared -angle_coeff 2*4 75.0 100.0 :pre - -[Description:] - -The {cosine/squared} angle style uses the potential - -:c,image(Eqs/angle_cosine_squared.jpg) - -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From 35f305eac46b24c3b982d7ae993b7013c09ff037 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 17:02:23 -0500 Subject: [PATCH 412/557] Update docs: angle_cross --- doc/src/Eqs/angle_cross.jpg | Bin 7977 -> 0 bytes doc/src/Eqs/angle_cross.tex | 9 ------ doc/src/angle_cross.rst | 46 +++++++++++--------------- doc/txt/angle_cross.txt | 62 ------------------------------------ 4 files changed, 19 insertions(+), 98 deletions(-) delete mode 100644 doc/src/Eqs/angle_cross.jpg delete mode 100644 doc/src/Eqs/angle_cross.tex delete mode 100644 doc/txt/angle_cross.txt diff --git a/doc/src/Eqs/angle_cross.jpg b/doc/src/Eqs/angle_cross.jpg deleted file mode 100644 index b0f3fcf83ac2621807c7ae58772bfbddd1d94824..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 7977 zcmbW5bzD^6xA)I5z|cr{2q-9_bf*F$($b;QT>}g$je;~XAdS-Lz|ai>LkbKzbV!FF zC3*S&e$TzneLa6Y_pbBW=by9pey#UjYkl@U`*!+v3Ap!CNks_&fdBw>_W-xEz%u|3 z7Z-wyg9m{?@bU2oh$xAP2nmVk$SFuEndn)VndliASvmMPS=o5l85y}mAMrfp7ZMU; z;S`q^6OiH)6cYGn5)eK&XZ3oEk0D5p17{mr(k%7QupxYk+ z%blM%pnnT;g;NcSx-gT(C2VjA~U@UAf4h}ZIk_G^77`W_6%&_u_FPd(`Gv|$ zo!7d0`UZwZ7M51lHnw*5P!CTpn75B_Xjpi}hmVm_iAkT6;VG$K(!PGn%P%M_DlVz2 zM%L8U)i*SDcKzt?=|%PRkDm30}z2hcfkXb0kXgeOJrJdPu!B~z03u5G!m-w4QHhef@`a zsewNTqKyOCdOI`h1Ylv9UamW&Bl(!^K6BSE%&GvO%=&U8N2@`5OU(+oIm$KgBBbTr zc^Kwze89I$7csG$A&S+yg`->G)d=nhRo8~vEl@mg)LikY>qdFn@>2FRYw_vErSi}p z!C>^@28+7H2yTt5D(~sH!#7&!m5BrMG31_%c!jwN@J2@Ifs$K%6Rum@fy02*qnyI% z<4PL)6qo>^sqd+G?$PjEH!Z)?kGPg-Mv|=`E9+8*C|>C zS(DRX=ifcgUge7N_h?j%#%^o)6Sc^ijMtRY_v(&SAb0W`5-E7dux_3^cfkf3;JTdR zU=9yT(8QGNa^I{Ge8)5)GD;<{uFB+h{5LAzIDISL?EPJ)(tv8@UXNRkL(2L4f;SOq z!g|csd<%452*b-O z&TF?;EG!?IvSE|x+biO!5X8IV^9^lmhWjBO|3)S3)54Rzm5(NArYQ&~Hg zHULjvIVLKqF9Cku!eT;~VqVDa%{}V|hAXD|atiWbxB09WOU%TI%P}739~6z(Ls7}r z@CAb|XU)SVb|*)oV(xfbuz6H&aiD{_>~1B(CR=dN_!b~?x^j@cd336}az?k{ zJJUi(tQIE(_*cY$7aPeE=O{RfD0Dw8j6D`dx31kBZnBnovcBz(B+du zIIH+VxJp~>R6xz~#xS0{G+>`H#I;^*6|HYJi5utOs7tlaxBnFxY_Q}4jm~~6uow>5 zPs!$)2!HtK(k#nPLEc#hf1Z&*L0-;sh4XU&kwunrz{TD-j9xt%Rx~d%>t|qQhj+6b zqH$DW#vHQ3`{;=<#Z9)?SHFxbb`DD=X(~v+Ojwpm*)8xfFYW_o>dZeb`+B|$ww1Qn zQX9KJwEQLN$MloU*Y{q?{2*d6w*_cUt;OJ{22g$jX6X(3KYB z$N|;!WVmFiwxvGpTRM5*@{b&~ZCQ)*C2S9TDR?Q0n*E7^?a$u=pjD>Fg;%fmP}Imp(^-Cu;X>KTvVnxK5L;@p=D#blt~rwy9Ncm^<>&GtB72rz_EX z@?Gaj=8L7!knbJ%rWt|wb`YjB(Q?3RWUj-#Y($MQ*Vut}T7)#W*B6c`K&Ub7!5Y;w z&}MJc2nNAxfJko>Q9F*}hW)CT^ss%H*`r3S6-qxyQvloZ7_(8@Pa&vsB-fn0>GWGs z-%Cx1mf~BZ9hla6-3{60TKHNbYN1;SD8ewZb3fvQ@H~b7lp=y!yq;K?(nEWszhl81 zTutf6lOuX*angYhbwgYMnNw&F9&Ykbv%c4u@nHV91h4Pdq32{MnbibC8TxUXrrPGJ z=A^+EG@sF!4LhzJUBP?TiVa!Y z%H7EWbY-l~wWjd;Z0*m5Qx5Tv(X~f8{iT-e;3qp5j$fdTwM+_tZ!*n8fHB1!sqNsyhlWSZ(3o)yd+4#D+s#pr`r~#e>8n1 zHNjrDzWrCP2Zzb9;B6{PD8;!R-e3N_!jVmfn{-a4^w zs&M>~W6Fmo7s(*_ihYXb^W4dP+4Zrdeg!Pn#RmAdU0o%hnaPegobJxSh2tA$n z_9MIsH%}*{gKkVkx|7>Gs@QB7!se=3$)|~Gy>>EhX$f*Rzy}1tR#AnE;vvt}d#3Rk z<5^epD!3bC?Y7r^Hw)W~4$e>%W0o>@lvOOEc)QUnv&gQ_*J%wV(7lnzTGd7O>w8DT zTLEz}X9me<5PH-kqxFf$*#1ceqq0g(t4OT)A38lP3KZ!p+`idZg$;HwCMy7X!LwIx ze-Tlzt5#liU}gQ~ulonbs=#IwflKUFh8V~60bL3TDBh9mAM#QRn_c4)<1legBw9-$pm>`=4<-X4unyFfeDa}P6W;p9?%0sd; zVki8xZpMyiE(Le9ybjX$By0D2otihqatJ@`LH@I#YYGc)0lU9Xu8U7KL}3G`rn6p` z`v-E=53?9-uljz)a-bM8L!z@X(&V9_dXW{|!DSe29dWzwY6Um^Jh77$XIqpoC9`~C zY(a2jK!#1{gaLIyVUz|7Kc1JeOT_!K?{RL#Rba=!@f|c1;X3FQtF8t(X&I!6RKtoK zjC!(R4n)L-$j3z5U%)PE^Diqa^KDGLOHPNG1U2icW~>5>c;jZ)V!qXfRe#nOznozu ze<~)9y&6wa6*V|@5er}YWNlNO!|YRyxyKz=(SBH)?OtR!Z)(kOk*k06JiD)8wGq{ZM|H*tYAYZkJ;B;;&N_P`+%) zF@8KTRUzur7*C<_;l|K7%Un~EDUbieS~{p#+OxuRyOrkfN#xgNIHtd!J9+G?@G)&C zEnPZGAhZ~y!SLGc5B*e2gWr>IQ5ro%@@HR#;`eqEaP?W@D+G0Zmyun`{N4!PwQiwF zE0G6-{2nQO1pf3@d(Bx$STz6w|(wU?jy#h zEFDzg@~Wo#X6A4)($i;uS=Db8OzWKg;a(Tk(`8y4$v)qBgp3hLjtadhgEHF(WgJ5T%X_||2Je}hlb?7>ldLEu zno2z9f3XJl^TD;?$jZC7l~ri1@vv~rGooeOQ%zu5({yW$tw}k)iaW>iEvb5*1!wY( z;mF-iMyP&Osj+M9BDk}mQFjYi=a6K^PH>J`m)OyVY-5CD^AM?%`wQZo6p6XxB7*0W z0lilov-wADRZb~FdEfDT2yqA&KSL*F)-u5E+aTwPiVvjjDBdL#b764$8 z1@<(Uk@1aj7sowaT?_O#Ps|U-{rIILZwC2Z#-t45?cxG^k&D)3yJ91mOTQvL+u3V4 z9m_DH;>1+<$}x@ibFGSVE$%)HKA#z%f){#!9Qr|8HX=ykB{#S$ZDO+Av-Fw7GY%1b zELs<*@iG_-D{qj>FN0(;4$A7FAX}qgS(X@ewHJwYL_9 zvc5r*1l$ywlg_)%YI%0qR$;UDq>ukD*e!@Cz1iPuU$ZDKZv-~>IGr52MSmbJspEIB zSf!-9SYZ}BHKxEB?;Md+dZ`;n!j~0trKWjUbjd}+w7%rh*H=cT2W{6iu%?>}hQP!5 zn$I4aPj0vsLAVAUrTBbS9KX>fuLw$g!wuX)Tj9q!Bm#i~Uc*H$E23#xaw#vm zRYgXrF$Q1-kwjE?Vj*Xa`#w!VXMDB=~&}i0i=jXxWLt48$M-|*^B6>8O_-( z>uZji^*OcuD#=-ltis1}4gT2P?%crGUFKbK_7eR>IHIaMJbAhnj&ETJS6sM~ z&*tdyXI$^o#?J+y+jFq}BF3alogC_~sYBHL~e_woNwdMlx+{R#JV=hS56csg$^+gZ8{b6+gd<5d2g%i=5ItAF;igUwu6v zTBBFnmh!`lZQ`BEuMaQAjCTh|P?|s8Ukm;U#(s?TjcGdLnDXF*vMh8n7tAtf>?YS`1k%~WNA8C1%C^-|a0(D~t9dY9XbiY&$AL=@0H*NGS^V&UbmfQpTqBj<~rN< z7KqCh^zyr2;FqIE{x|8ZgJhn1-;7odW2AmQk%U=f*ks&6`m2gk$Q1ASY2_7o=hd(v6bxJ zAqUTz$zc#9{X_s<154Yfp-H+c$>VQmJZtsYn$K_ooF~d$3*RO5?*l=y{P8!fA z8!BWRW4lBC;BZ_-$lP<>nX-f;u>?C+_vgD{b(wpki<&j9U!FK~B9n$f_vpiapyFmi zB$I!(a(hJqTwnj)$^$G&zS&Qrkt-rQYs0_mu8+f5CQEG1n9)+gh2;@RMBj~`%tcmk zB83a_p_qz>wM{J zc=hsfkzL8wsp)7hSNtxWq`_4oN07RNC)34aE^zXg$Gmcv3`K1fdXH%AQ`L^+18jNl zE0Z3&Sd!`C(Vr$BR7{l-cfW?qPirQTdrThHMDCxy=u)$L7yy(d*{NVSk6&=~+G@qu zAcBo6ac2)hJ|w3$TdW-)PdcL%Uw72T1YOkXWfQ6ICRYxDuXT#eH;iz3w3&$-PtsE! zgA^~GA4z?E4-rxpPDN%9lb9mXr56*5jptvE_K}A__pe*@?CZ_Jxv-i;7(Rud1LIpSV16pEH}tis#+(c2N;&RxKt!g5m}GUvR{w z#%q}Q3^|O-;ZSPH;pnuE?Vda;%WwKL=E9ik^8gk4e7071Z?sIGFc9wdIvtx+FHv)y=nC`G2>gp-H=5KN`8J1Dn_p9Ge= zDje5Ae)1ZZlJ{GIXy3Pm4-c^8eAPD0yAWiS)}=hF2#Eqpi?@E;V{{iX-34*RpI`?C zdIm%OPI^UKwvME~ngCr|l3l}hvGfO5na#7BO#ItpzpxjH&3+Byo}Mw@Y7D4}$usA6 zu!VEQGwvzUf{&M-pA)XRdp9=3!S;%jwH6&za=b;UfaF^Stq;ih}eoicEs@kfB-5Zu# zqv1z2@RA z*TTVe-)X;`S`ij4GxCCUx!v}IdTy1VX@CgV7+0d$sJ4)1Ny$@6k{|+LLrT{6;z312 z@%H19fF@1&anF0}=a`S*2s03PB)C3~o~35===GY~=GNx8ftK-oqkT)M)DDmqX=Bev zQpeD!y8t}eo&@WTRwCEqd+NN7^B1+yLB1wmC$m4xMSrA0O7G=tQks z*Ckkm@ve=QNL)`5#NsYz)ejktBUPE+CW^Axhn^bcFv+S~$(1Se0|vs#x}8EB)yEwDgh zh?tXQ@tDkyNUJqKs3eDvE{eyI0K9NI{vV6+>xpJ_g{?WPE6q}O#Mzikq@|I4M z9?^T)AKeRM>!p?s^||g`al$25dP3uH29wYoYN`3tKGJ{mT)FR_PJG3SHD6u)2U91c z6dlr2Vf%yBQ}>-L;oEavSQIsdk2!dTU)PE)F_PqEtwaH9S1LIBZ4Q2gU6y@r1@jm) zV~WQK?qrj%NcWQvDa5h8xuqgrG@|cC)6Ej`dH2xj#$0d{TrU9{XplP48S9&I+98dl z^l`X9s%)J&Td3 zg#>B?jHo86z4Xzhe4&;c<1G-uI~1FAchj@Ca^NH_GaTOYeDa#z+4rhm?+k*VYb)IJ zqPP6?0I9alqk!$hVMoW#bdQ=7TnMhfg&GO{yX@~uAJ-9sn=ZYUA}|ZL<50;{+xykW z22jlihR6~2v2?bEQu?bFn3$Sv`X-k-ac`w8K!4=ndSgUm5E(=}zrr$Ya>#PftLWh92knxR92CtYN87FJwmhKr z><7lW((Y@Z^}?*WbwkT^Lh~m?aP()+_o_rm2|+$XUX+>;-b(qRft8=6^Tu|fqSTWD zul~GDd=8M3X$1}AuU+WtC{lucVvI9sx@p>rFR3ebB%U%p=*&^p*=o?jJ0o7C8?PPP z-4kZmQ=qM#e?uusPR;4njcH~MBGu6OXOS}B>^ZqP(N#qpy!4DWQyTpnmz`n_5@VOF z?vNJScF06q9P))Oe_D3RAA(6?!U{T3YWGCE%HC_Lika}?6EMVdc!Oi_GJQkpKJk1@ zX1~d1wO!CabNZLnG>1siC)`L!Whp?cM*z7&+54|Eb*G#BB0beuInP~)E%Ro-y!(w0rwwOw#PUo6!Ex68tSP(#kQ%1 z$eV*HB>}piwO};op=_p1koZ~94l`d}Bj$Z?9#1f1EJuSIa&?@|8T+Dv>2=iRKl*VC zkQirDtCr)BfBcrF`sraWDIvnV;Y7*2{${^xq0(rR-YK(RgSdf|%qvW=nn$sZ7opO* z!C7b#o1vFX31}()tAWx3a_unD2f~97(hR}`!V^BL(sG2klF+#uhhDEpP^6i0k3Aem zHpwD-TO9~@98k;He20`lRaoBG6-$CWZew+uIVA2~8uj&u<)>{z0>B0TlZoz)(^Zt-xf4~{+nN6Wzc4n8 diff --git a/doc/src/Eqs/angle_cross.tex b/doc/src/Eqs/angle_cross.tex deleted file mode 100644 index 9d1fdcb7f8..0000000000 --- a/doc/src/Eqs/angle_cross.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} -\thispagestyle{empty} -$$ - E = K_{SS} \left(r_{12}-r_{12,0}\right)\left(r_{32}-r_{32,0}\right) + K_{BS0}\left(r_{12}-r_{12,0}\right)\left(\theta-\theta_0\right) + K_{BS1}\left(r_{32}-r_{32,0}\right)\left(\theta-\theta_0\right) -$$ - -\end{document} diff --git a/doc/src/angle_cross.rst b/doc/src/angle_cross.rst index 6c79776493..7dcff0264f 100644 --- a/doc/src/angle_cross.rst +++ b/doc/src/angle_cross.rst @@ -1,13 +1,13 @@ -.. index:: angle\_style cross +.. index:: angle_style cross -angle\_style cross command +angle_style cross command ========================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cross @@ -15,7 +15,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style cross angle_coeff 1 200.0 100.0 100.0 1.25 1.25 107.0 @@ -26,13 +26,14 @@ Description The *cross* angle style uses a potential that couples the bond stretches of a bend with the angle stretch of that bend: -.. image:: Eqs/angle_cross.jpg - :align: center +.. math:: -where r12,0 is the rest value of the bond length between atom 1 and 2, -r32,0 is the rest value of the bond length between atom 2 and 2, -and theta0 is the rest value of the angle. KSS is the force constant of -the bond stretch-bond stretch term and KBS0 and KBS1 are the force constants + E = K_{SS} \left(r_{12}-r_{12,0}\right)\left(r_{32}-r_{32,0}\right) + K_{BS0}\left(r_{12}-r_{12,0}\right)\left(\theta-\theta_0\right) + K_{BS1}\left(r_{32}-r_{32,0}\right)\left(\theta-\theta_0\right) + +where :math:`r_{12,0}` is the rest value of the bond length between atom 1 and 2, +:math:`r_{32,0}` is the rest value of the bond length between atom 3 and 2, +and :math:`\theta_0` is the rest value of the angle. :math:`K_{SS}` is the force constant of +the bond stretch-bond stretch term and :math:`K_{BS0}` and :math:`K_{BS1}` are the force constants of the bond stretch-angle stretch terms. The following coefficients must be defined for each angle type via the @@ -40,15 +41,15 @@ The following coefficients must be defined for each angle type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* KSS (energy/distance\^2) -* KBS0 (energy/distance/rad) -* KBS1 (energy/distance/rad) -* r12,0 (distance) -* r32,0 (distance) -* theta0 (degrees) +* :math:`K_{SS}` (energy/distance\^2) +* :math:`K_{BS0}` (energy/distance/rad) +* :math:`K_{BS1}` (energy/distance/rad) +* :math:`r_{12,0}` (distance) +* :math:`r_{32,0}` (distance) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of KBS0 and KBS1 are in energy/distance/radian. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K_{BS0}` and :math:`K_{BS1}` are in energy/distance/radian. Restrictions """""""""""" @@ -64,12 +65,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - ----------- - - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_cross.txt b/doc/txt/angle_cross.txt deleted file mode 100644 index d9d83ed4b6..0000000000 --- a/doc/txt/angle_cross.txt +++ /dev/null @@ -1,62 +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 - -angle_style cross command :h3 - -[Syntax:] - -angle_style cross :pre - -[Examples:] - -angle_style cross -angle_coeff 1 200.0 100.0 100.0 1.25 1.25 107.0 :pre - -[Description:] - -The {cross} angle style uses a potential that couples the bond stretches of -a bend with the angle stretch of that bend: - -:c,image(Eqs/angle_cross.jpg) - -where r12,0 is the rest value of the bond length between atom 1 and 2, -r32,0 is the rest value of the bond length between atom 2 and 2, -and theta0 is the rest value of the angle. KSS is the force constant of -the bond stretch-bond stretch term and KBS0 and KBS1 are the force constants -of the bond stretch-angle stretch terms. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -KSS (energy/distance^2) -KBS0 (energy/distance/rad) -KBS1 (energy/distance/rad) -r12,0 (distance) -r32,0 (distance) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of KBS0 and KBS1 are in energy/distance/radian. - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER_YAFF package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none - -:line - - From 954be8483a4d3bb085cec702c956d7a226f80cc2 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 20:44:22 -0500 Subject: [PATCH 413/557] Update docs: angle_dipole --- doc/src/Eqs/angle_dipole_couple.jpg | Bin 2930 -> 0 bytes doc/src/Eqs/angle_dipole_couple.tex | 10 -- doc/src/Eqs/angle_dipole_gamma.jpg | Bin 2709 -> 0 bytes doc/src/Eqs/angle_dipole_gamma.tex | 9 -- doc/src/Eqs/angle_dipole_potential.jpg | Bin 2616 -> 0 bytes doc/src/Eqs/angle_dipole_potential.tex | 9 -- doc/src/Eqs/angle_dipole_torque.jpg | Bin 5110 -> 0 bytes doc/src/Eqs/angle_dipole_torque.tex | 9 -- doc/src/angle_dipole.rst | 87 +++++++++-------- doc/txt/angle_dipole.txt | 126 ------------------------- 10 files changed, 46 insertions(+), 204 deletions(-) delete mode 100644 doc/src/Eqs/angle_dipole_couple.jpg delete mode 100644 doc/src/Eqs/angle_dipole_couple.tex delete mode 100644 doc/src/Eqs/angle_dipole_gamma.jpg delete mode 100644 doc/src/Eqs/angle_dipole_gamma.tex delete mode 100644 doc/src/Eqs/angle_dipole_potential.jpg delete mode 100644 doc/src/Eqs/angle_dipole_potential.tex delete mode 100644 doc/src/Eqs/angle_dipole_torque.jpg delete mode 100644 doc/src/Eqs/angle_dipole_torque.tex delete mode 100644 doc/txt/angle_dipole.txt diff --git a/doc/src/Eqs/angle_dipole_couple.jpg b/doc/src/Eqs/angle_dipole_couple.jpg deleted file mode 100644 index f16849b2f9663e12ec3148d2ecdd8ba8916f00f1..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2930 zcmaKtc~sI_8^?c$CQhcJqos(HT3Uvdxuv<3B`%Xro92Q`ZWX4fV~PuAWnwC%j^YZ_ zs=4NpONH9xzC>yygoTKKDU>U&=<9Um{p&sF{oH$=f9`Yc^PKO!-}7uTHpc)3M>_{Q z00aU7_FD_sWC6B-6j)MH5-hb9q@<*_Ny|c{w~*hyT}Bovuc!!>heDN9)ORZVs-_Hu z?%K0U4Gu>j5K22WwKX-g)in?rn{B{$2oMYmfk04TvmH{B_tq{V41B95Fi1Tl!9(k+#{`YSo8Q9Kgh2tT81aWlayWEGWVVRa4GB0 zoZOl>!}QHh0A#Ckz#3RXLjNBq{t@LvGhN802*n0e)a4Q)c{pig^hB3}^^w2I+-c{Z zHwn5Bou~}jX_H{h{l>L^p=~^)nu%^O2gIq86;4E9(i#^g*=PQ(VH1E2J&?@2>T=F% zMbkX;uQqhS5wS+Mlb7`&N8(ug61;Ezb($*i$^FzO&%YV;}BLsF?sp6 z`m7zsNuPV)K2|tm2hl>kSpi_5G`C3ZcmI0E>s!j-oNM$cYb*wdj25jCGOBlv@L6lR zat2w8zx*g&aa^f@%Owk7>*Oum*PK0QNG zg|scK2W(S}(?G2~u0_c@=eonxLtv3be*o(a-cD&pwKM&Mrx4uY0cYQ*eSwK*U%W%W$n5hW89(@P4C_if&Faw$Xx2Bi z@K*}@g~VEY{6V*XD()^cx@#x8ZXndjk}v)-QJ$r#E9XGz9j`)3$th82c9U!Qlc!Im z`!V4Va=SD8X1v5Pq6Gt**x*GJ>+lknD_q18wSGuiR_EJ@?`ph#5nhSsUrwSAdT58_ z1!R&@6geyTVt8`Sy!CSSLJ8+0bkU8wD-Ju2T)C2UN$+oY@l*0U@LDDQroFbramG4n zpUT&?Wk%(v&QG0=bHb0cJXO^a1(S<>({5l{=M8L-fyO^8>a&nLqOUhFr32@-w~sVD z;hp*pt+fzG)KA{Wu>-fSdAf)%b0|xgO<<{7D z3kjQDd-mAfpfr)ILnp(M9~3m7?eyFeL{Isc|A`3mu6Fy|14pTHzZi${>v(BxLmwfI z?Hw1=yi&As`wd4s>9OY=HGHRGp2Cyfs9BXCq0uCZfc5OdJ6Hy7b(-twQbEDP=->6z z`$raq!Vrs+1hIv1BryT&y{hDNDI-qlLhj?*_K_ADC#Ugn*un5CNbPvI;<1>$HuIy# zdJNuIc2>~NJ*gPMg+4gwJSJ?(#O4ou@U-7<1rQ_BgEwsEeU|nt-{#A?3r)StHOlyz zPYI}OWW>n>S+cg(|h zYD)+~>mhYmw%>snf;m=FWqAX}3M_lhZAY^trJ4JjCyIY#e4ep@*5bO3H%G)W9gX*N zc+@F3I{f&A@6@WK7jAQYCufP@0k?gTOtJY$8%+T}Lk|2WV z?ZC)0#en`lj$@ zqqxs!k<>Ol+(o!|c8pQp(${WXL1p_Xc`w~^ezlEqf9R?Ltpe*8a$0~ z?S-H&!k%+4AwJceUFUL(UAkfD}DKPGfb3=8E zXf#ka9~Yxj4_jmIzSG`?Xg}24@n}w8&$#l4^f#!H_hJ=2+|ujwBr~BzB<*b-B^d=s zb6@jUilR#&Zs}G&M^N?5obcJ_V(=%<#MOp5dphS~{g?i`c7iB|TsV9I<=c6CL16wK zzs0@ku)D6*9(Pht;2g>K?!2LL&Aj8Vw+u@mqw4ZBt31BRH1<2+Ot3h8`Q%SdA&R;^ zyWXnj9Ky=JA`8vU!;-3eM|zeX`;IJVmxU&h=hWhf8Jwx>vXj|5F|}>QbamAW6;=}u z1{u-Lgg;J_Bp@u*2VUlbtxh#Hbt`zTB6Iuva~XjVoH3GBQBHx@I+1D=ocLbZEv+cH zA~xsV`0Px2$JM&C1)X+r`)b7JLm-GR`@a~CGd+jVse>B3g#V7FOD$xl?xQ|s_~271M9=Oy!QG!dE)%LKuh}wP8|nVO)lHymOR<%yf!idc ziQ)buf0holI8nQ=u%hw`C#KJuoAodTt!)Mw^K;i}wllfd9NHPGZQ9YiE(>c4`GwA4 zPWn>Wg|IrXh-X2YCAM9`#5f8$Ek)c(M&pHH?j%a4Kv;bxn;|>L?~Z=BBp_WbZYox` zNRR5`mRoDd9zy?d&_wgDt#(MZZJozBDDpT%GO0#{*#6+3_g0Rh%wAj}YSbk)=J)!S zdfjqd(t0>q5OQ*s-XBSU;nf(cPA=Kh>M$8@#yCTbVQuK5hvi;easej?{$8-)jGYMkkUM z-X;w#ED_zfjF1-BcbetupXkUnxe!Y-zbVDgd`2F2eBBjw^Fn1XZHVw)=lPr E0Bnnup8x;= diff --git a/doc/src/Eqs/angle_dipole_couple.tex b/doc/src/Eqs/angle_dipole_couple.tex deleted file mode 100644 index a857d83d7a..0000000000 --- a/doc/src/Eqs/angle_dipole_couple.tex +++ /dev/null @@ -1,10 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -\begin{eqnarray*} --\vec{T_j} & = & \vec{r_{ij}} \times \vec{F_i}\\ -\vec{F_j} & = & -\vec{F_i} \\ -\end{eqnarray*} - -\end{document} diff --git a/doc/src/Eqs/angle_dipole_gamma.jpg b/doc/src/Eqs/angle_dipole_gamma.jpg deleted file mode 100644 index 4bf618e2529f152f2cb27952ccdd0ae7c00417de..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2709 zcmZWrc{J3E7yr(fiP5u+v1Ke_#8^Z26jPWXWX2LRD&k2on(VUtc$$f& zY-MR7l&HzRlrYKU>DeM;emdvZ@BQ)az32Y(x#ymH?!D)JE`NkS1&G_*;%osB2n1kv z72uBp#{j4R1OgF&?m8$Gx<~LgA;Db{+q)O`8(d660xkxJBc$bJ5R!6IaJa0ptek>^ zl9CcaMg^s!h>}-SQsh4Y_6h-bfDHn{0e%Od0Du62p9TVc31l}f2rK{-+Jz5`10Vqi zNB}GVfdPAeM(iRG0J;Y*A&5{`v6ht5mr-@`5t25*xKR@G22h50S9f1VZYk#-e+&@% zne`~J^NNYK$20!rJiG1%SaYeA-r!)UqOkY(+48b@7+Cr3kA{ST@;LRP0@6|sqR!!* z@u-+nT(`Dh^rLI3o&;RjB|9mU;{J=VnCO^h_cjJIK(U}uFmGR%emz?<3LQB|FDcwW z3DNA9M|XZNUcD3VAKHa-daaW-?q_MXzQ0=G6Hf*0@2K|nsl01eR3d8$#^rInHh&cu zdVTf#upS4ouWQ{xPxp7xNPUAm-pC<+n?7; zoas8fwd5J!?ALhWXsM^MgWp+8N+OhO2R)o5Rc)5Nh-f<=53B0yMX)Aa*#XsG)44ZZ zJzngwi;*n27+!I<9Q+}Oo?SC_9$dIF7=PESzoBvjcREx2ZgG2G)1nf1E}BR6@r&UD zmyI7-HbBg9WK0vT*_5Uj&IeFS98!>^2x`+Bf)f60od2%o#Oa;@=hw>t1%!j|^Jmg; zG!+SF&Es>}rP1bN?SLcE`vCTu$`8v1*X31)LG`mN3k{FK!BBi0dL6clU-17m;HG}Z zsrO&EJ$cgM!7aAeWheF=c_rZ^!zn$6!Q|29t(9UMsV#qOYZ0ldYo?R$XLL+x2kHzK z)}{pWK_AgW_?L__FuOE)g@Zv zcv9mer9ozggY-(pN6sq5#MOIa>P$sZX|5k840FwGcxwlEEB8YZoiF`|x>M#Ogn_rm zTfBMy0A1KZ-F!!@En})-9o`M#!zW;N&rSB#%w*xYI@}!)BR9%ETuUpB^hH-eRGZd@ zCZBlJdr4~`KdtLGwalJ+3$=R2wlLj!KqM>%-`u&b-aPqe9C7bka|W@bqYn9ch=9X| zzws6^Qh-_|Cq*zdz+nIsmE*Rrk5J&lA=c@1b7g)|MT!*jza*~T3?2wxzwIoU79F@nlM-_&{!;;^4P7&2M?c z@2bY@3f%P~S>Bth!YdTq=>0pN5_Y(0d|t44;D9#-VPeXU|C^TOU66_qJ*< zn+zW4PN7ZGt5344QYOxzJrp$+=TT9Uv6K@J#9sW>f1D<09(Nh_Sl2a0Hhj>jJFfFG z@w$oz^2q;ArBukb8yN{Ay?mff_rna~FFpAkWC0)e-Mjro+1P2bA0~!7y^j;po!Kp+ z8{~lPf(Sk!*P>T(ikC%L{_)mAZsa+6TxnylprgvPFm;Mdm**Mr=Kgkka^e+LHJq5@ z11U#c*guNTRMS`}|I(LaHQ(TH`(h{SR+{Z6_N$4edw%LAj}DdO^pw$a%eu|SY+qa( z**`Gmu7rAi;0}|xNy})JGWk9DOTE)|^o3&tl?tDZj6h)>)?TFWG%E=oK9!jfnoL^3 z>c4M#y}K{ty82{y@-xPkOHl?>oJkia?G?tm7K%C5&jxMzM-|SPWc#Jl>x2IYY#@0x zw{+mNvYJDTYRCO5*brk$Oy*Uo^J3UhV{PJc`Hhy8XSW=OhC>-N->w|xU`-2OLmeIA zcNc|)y`)*^FWzWdEoeR3MeJA-lHS7@%aPRH=9n7O>nr>`eSCmj!v|Q-wZ0pJ8JJm5 z{c)R`IrvlZvE*@0d}OOc77QuSN#y)PTP6LC$L`G9sZ}eunsiW&OTZ);9>W&RNXi^O z7jyKaQ0^|rJq*BKzLlQwl{WhD^^1t`os9__=ByMYl{&O~wG?b=E%F&rEu8qa>Pmx~ zS!Ly^>RYiVy&9`y_kUTEb6~!(Y_j>6YD94lD0Q8+juf51nCRAQY?V;Nt*t(f}Jv(A`++Ux>&`$~FHu z%&R5Hhamlj7chDu$Nbt~s{|P{E11~7oxwzVc6Mud$k`ZYoC)^Xk6U_VkBC%?R$B+jREI38`z1NK73ekt(0Fn3P#37kkm$c7z(k3x-s&aX2%%WDsfyQTw>cD9woXiLEA`JVYO&DNCJz{Uo>95#5F}H| zs+s#E@I?OWcw|W5V6ER-gUZS^CGE!6uxtZp3E*#6R-9(WieG4* zrjv2G^p%#fo0RYEkgFA|#etfbo#bUJjoAo7Yv!L-CsdKL6X>U-)UYkaIvG*=ZOf!O&MF0Qbpa`hN_kz zrNkOaMX9A!?ZgO%MpXK z`v9l2fH?pGb8~ZpA>Rc8f$%^Dc%k1B;^*fRfC~u=!-e2*5rmYe$XSVVaJZP9n1r-6 z5{VQMl}E|TprmAwGN)YtKQC|{I0Av-z-cca1%Lo9@Q)k+1;PX7hH`;;zq`6;01!79 z7YGdE0YmtHBz~m1A#fgHIjD%b=~;xlhJ*Jx(PRZP#~b0iKG>YxGV=JR(;0yG$HvRR zabDX0#e*bmyCjE#Ve{nob5Vwgo=^TQe>r-F@N0g-el0ydFO=rJyzdy;V$^9fbe?mJ zN%~V0H${FE_M7sZfMxzg@S=_-eUSoEYzs%l<7Y5>`=@|7p3kQa)$6BxEjRTI8=0vZ zlQJx~LJY2e3MQCxP6~AxSDY`nM&wgyl`RWaM5<@*RIB4GtdQD1%`f)n6lX7VHQJ$r zgtx;^FRkxsK8mP$qKQ4$-$O#~gru3H9zv%vae8A0A%Z{*3MUiUu>F(X-z{xVVdlAg zSJQF=3U#Nd;Qraj!LNf~5qrpTHw$8kvC)!-ON-E@0V{6S)!(~q_7GZx(dOWK{Tl{e zs#!)g;AJYsQn5z<^M77hejun4y{&0Vq$={4LMMx;g4vz!)6@lTW2wa|H2tr%VCjLx zGETTkNVk@YU$rZZfuUWvsWQM%CyRx#_&sGtx2Dd4jCim@PPk&vn$AAt!=|}&BpbQN zrz#pfqrGqAJGIs8;)<=9d(G|}*6X|!p>kIyO>K4I1?PSiL(?bKT%UQ(;&qJ^pX_t7 z^c)y{y`qI??k>9-Wy~{O-yTW`XEKHxN($2(qUPP%YtpxVb*clz{W%GqTFd@!Xr^2Y zW>&Jb$f(Erg%>I@v+#KH#Ytq?$N}aQ*z#Oj$t}{9JYp=3-R+9RU^W*Lp?jx*%JcJ@ zC!fb$`@aQWfK+s=)w&nIB&f#~>F|4PS^i1q6Xd$c2e6~Ny))h$}{gXr5W`YG}k$H5WNHwh_3{)8>iQ23`6IGlpUbR>JH5&O?Vasm$6etp! zf`HeJ24((W#MI)ojDC}bnFa`EKHoCR{w0Iz@D*{f8Qa02P;yL0gFtsy>R4HL#lHu~ zjux;sPAgCE^#v$6wZq8LfrlDO2IM%?^8o?(nC8ZKxZ^V#8qKq7kv#EEAHUR|H<1;! z@w0{T#cfes5)_(q&qSUmijFc2(c#-r63X9hU#@lWYp)bXm55^la|;XxcOM%nvrhBgxpZ~3G*QGhpm7{o1lzq2&i;Ebj0nW|qX zRMuNI!vXvC+T)%N(lS1sK0CF7yGnY?sJl7QpcK-$2Z}xG)(VwMJ<`Qp&am`~wHtSp zKGfD}&lj7)zn$MjHkf4&V?Blq&}!DjC0LJMRlzSI&)9qKl)BJn7zb*%zCj=h)^y2* zxOm>;#A)X;r^fyiz&81=%;BED~U(Kva@;RKuIH5td;?D*c-wHh8@-(cwdR zUpKZ*W^#-+uy5EmX*3-ENIj*jm%T}@EeqvPLk~jD2`mqO(nY-FOS9bo*BqDGI?b#Q z7%Y4)DX*jMXf`BW_R*`k!JMI#!x5X3@J?S(zM9#y2O;7tSCUJ0@s|JaUWHJtPY}jq zbY7Sy(n(9GXJ= zt0B`J)^DdU^Y&X;3vArwd|QX?8tXtqvW@w+r+{p-&JOioH!?Zi-RxnVy7IH23gHs?XEcpC2Mq`NY|syr}GD z`YUv0VhO9xp6x87oU($mS|8Uy42D8fR=>_0sUQY26Jp zY)4F_xx7fBbCjPU06=j7b9d)?!PRn(yFVdyr}z}OgKGxnEsaz{TqYjb_i zqvAlqtKvzB^+C_?M;e{DeoiE^YQZCbuY}05{p_Bxf?1{yyB_*;w1dQ#4sTqayoS6f z=DL=&K+oqgQLu>He@1`u+82UnKlr#-@4{%YK>5PLa;`6FdMrw&Z-ximRxr`If=GT% zkW)PIez+n-9n-p}lo?UT%OgR!+2N6-l-qQr+}cp@-QMJpFi1 z9NA>?i%a7bXMPXW$+f(e66taP5#|L;3LrHYY|`lup=7DY z$rB6;*g_{UD70A)Vb}4Om_n4z^}K?Llv<{QiwfTBm_Q{Tk>JTa= zyKPQzJYh(u;T9uiYW!-65RsJL>-5gi+utorqg@T1;M$kk7{S)R)cA^~+U@+|J(VJK*inR`mKJ_a%6}S^nRtDTQ-BeJ;BJ z6U{~a(}Pyv*@zt5RGh31VhD7@qXp}^}U{-P5)=GomZ zBPfk)+>V{l!$&Pl?!J@f9fkJY8*75Z@-$9OwL6;lBBw^h^L|5@%(OrVx;oQR!FNL& R^l^JB_z(I2!G+W5e*nm(<9h%A diff --git a/doc/src/Eqs/angle_dipole_potential.tex b/doc/src/Eqs/angle_dipole_potential.tex deleted file mode 100644 index 8949835eb7..0000000000 --- a/doc/src/Eqs/angle_dipole_potential.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K (\cos\gamma - \cos\gamma_0)^2 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/Eqs/angle_dipole_torque.jpg b/doc/src/Eqs/angle_dipole_torque.jpg deleted file mode 100644 index 996a9df3cb3cd51f23678121f6e4765a7aed35e0..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5110 zcmcIoXHXMdmkuS;r3OSuXbBJ@`hp75OOS*FDM3K`E9IpI3`IZ@LFv*7T~Htq5JPW4 zs&uhXB@{sd(m_E4>Fe&S^ZnUB-_Gv2GtWFT_s(si`USv)(KpZsFfcFx z(7zYpbP9k30GXJXnVEpU0SE-1Vc}$D`EA@B9BiDt+R+%odmG{r>+*@WPl9E;E4Y_NYBViwHHg#Xm%3&XYg^u=G>9IvafzT7Z#4nF@UVV6& z=e&FI1^t&x;d|G7-%IXh7uyti#=!L=m}#4EL`qQ$7i7tyymlge^P78b@0{RrgJH^o z%mjW$MHg}lzO*z%4{w__0pP{=#KrLTt`n6Lmg^H`4_fYI*=8GrZO`Jl$m)qi5)5PM zM3ZU5-+W~d7`;w0Y$eOTCx!%EN1u;LXXwsLnt_Wo7p<1-xw&z8{3|f;XDbxFRIXM` ziE`9@&NCFq2b`;pfwiQpMqe?V9SYH8-yr>oVQgTNjr{j?)o+AopSV;$2jYRX7yq(~ zYz!diTHA{^-k-5=EtGm0)%1>}Se#w*Q7 z)BVODm}wM54rsFTzUM?62$#Sx1`BOYCMlGO0)I|X=(#@UrCiuwpuqG}6~ zpJ|ClkwI&I+L4HmYsE2x8--?T)>;!I;+YS7%KQ6F#&=uC0z#)ASU;qzPL7(8zBPIk zXp^|0cxy5Kg0H;0RY72QvR@BSKMy3I3zEJNOBH`o%?)lDC8at;H4u5-T( zykCKq-?vGYIR*Fy+P#LE=O_fzHtOgFz1ceK>Kw7od5oljZqKGbYt6K;7Pd{tzIjhv zF@5syy4}gTA%swoql}wm7#f>n9kiBzNVYzDsc+}Bde%4~WTM9MuPJBqJMmIeIjK8! z;h)Dja@l-!Sc&gaL0zg<1NO#~A5>(=cYp z&zHFpjmfhatM+DI^~Hk1E=I2+5|WAHAlcn@;v?hd%%4y*_9~}<8}Cj5I|B`;fSear zez}O5#rI9}@_7yUP#A9ONxVf=xTdS!ZCT^uZlo)6G%hdCnRiS5;*T^e-l)p+(Ry9| zGxP5{mb?dfo(G>KyY4;qUkNC>5b5h}Z|vuBWuB{-uS?J-0BxNOkkBJ@r79ViisvK$ zzL~3eUG1;cR?7s`Gs#)^Zd2Y&Jv^*G)d6oLTk6b5l#mc-UQP$`p#kQ=S&e?LJ^6W_ z_}KBX^zah?xfbDwi%ykd)=Xcdl7P*_NHWAuu8$Q8{$xN6gm_Dm6MzFEJFUh%tUYvmv4UmJWFKR)@KmQ>J{DQy?;+&b^RgY_yvC0z}K zVQ6UMf(z%1s?qNhXqOf4f8G*0EPCRuHkOt5|m>L_cq^(xv`#pu!kH)U}p)`W? z5i(^O+b6ZHo(nz!wf=WnJHUO<#e!CFc34Bj$ZKnHs;p=c=t&s+k}$Wq^!zW*r!!k& zv*OlH)nd0&Bo!T4O&QdDx}dV#5VL6?lzz*CFnU?B1Tw{wl2&b@?L# zab-RsS}meTYQqpu)VZ5jwm30cZi%TXS zp_$i^&Swuobfp7*dY1b8K)0#Rsb7DcaH8^)fN=WMZ8$EKKJpbMHDP0_8Mgak`2{$Y z?z^3BC0?s_;S>;bZ*?IH_teV3fhX!3g0#Yl@#mH_ItC)E=YrF7%lFo27`u^os@m5XQBf*VFu^6SpW@kjKA(#jz_vE3L$jl|7_r`l#rp~>ad3+YQV&R_= zr}5GY_4Gn2kB+K4nxXaHkmy(!AA?2=xq~1d4d|Zk+A46*^+^0NP)Ak8QmCK?TU;j= zV^Sd?PO(-`zL_U8P;UOC(*NXZjAKwsCWu-&pHY^ZR&Hd-j-tbQNGv*ZZpLDJOmqnv zy-soaJW1&NaBugvCahJodn&Rm0wpjPpegPkBWRMarVS-*)CH>7UNui$dFy28C($pA zq1u&ygMz^OQXY~)rvM3gxYKXcI{#@nok_A*r;T<|P%hX0ib#a3WS_R`1-v`lWVU@d z|7TjKmvDwg)SJ$C1I}6BrCtblw#C=>edoJYfN=^pjv9nAIIlU;eIsGhbsTt*VgA`ru*cWnWJ66VkZ}yG@t6kTC0c zy;$De@%0rA;u4hn0W%y7I)E}*ZaUR?Pmt4KuXXC)gno$b#Ks*w3z!9oUIUfZx>r?~ ztEyS@Pucyfi>IO-4@VoE5_P6v3AZ_9`b2Z8lLJotU%-#G1NX}^tc88&2J@f&op3E` z8?B7B4NlhWxCf7hu|M!cZxYD}xNTziq<=`~17*tlP?;zxf#0P}Q*$`40{8{=h# zv=^{`W|k6%AyJG1h#H|IgniltB`Es{JuW$VTS5J$|`~DPodKYU78Xt&DM4v5o8^%ay(L+6|f3*s;*h3j?ui z#ySlugdiR!uBNDdG5)$_HFKHy3FYGi&IsYiI zfD{p~HPegLbeVf*m#{bTZ_rU26i!vky&hFRbr2g_C8)@Rm)crh9TdyH$Y;E00L@<{ z->0p(zH7d`R@Hj&|3#nhmx9G&mAq)jdT)j#eTNsKwIGR@wgv zTXK1c4v5UGgeEJS@32Co`z-(wB%TZ+L)XUjLIdL8*KlSG<;;J&?{&?GV{Gh>aFPVO zfxI%vSWPZVGv*d1Xls+o*eeZTG{7 z>uX5rrdPp0gY<_*?Ji|2Z!@->y~FcE5>B1x7iS?Z?P0_%spLVU*B&q0Q>SSPi&vtP zr#4`t(xbdBWnkSCuW@KOT_Iaar@jM{N(`nCh z=0UnqwR5AlmPZnJKN~n^s0v}1XiQLSa3H8ky<;>vbBK2k!?ZP_8)yYLUaRoFha33n zM05G5Z#S2)Ja(6}8bt4?0z!bd#-lS{OxVP@dzZqYN{>|J!1>7y2vhdaeDC7DM=Fe! z-0j45pShMqdUXq5EX#+bV*)67$C0QAg38zS7Mq=i-;suT5ShQ)w^>dlU1%b(z@0v~UHtC+9;2N!qQt znA*ctT$(StDQ+sGeAO=})-vWUNj9D95vj}_;PeljCJB>^)35M$w^RJ|Znf1Em!qU;`VgrW}^S4G=u%J6`76|fRy(1*d!CaJs^4|uewAoo;OM}<4{6dFwG3A_BB?SU) z@Eb+j&(}?|LgiC<7xq|D?FXljwh-LCZ_)&4G7GSD}zdSE43x7 z_d;}+g4=rRKK&Z0msM8sHrd!fvf?a;0rcgF9(?d|F+uU4c9O~)O5?pMlmp?cje3C{-} zli<$$eFcTqMqx9fg$5>Uv_IJd$5>`Q#b;!!m0?75F+?&Lz*2hkO%r#rox_Ux$sxYd zPAGZ7QZ14$V$^9Z9Ml{LwpWaf;+-QGe74zM(_01yA}M>GG6owK=s_WHpJ323`Wd*# zg1U;y6n`bBSClg{eRk=YpT+Uz*VE<0+a$x}Yyy6~u00xBOT4y>&uF%{)i$7S=V=el zq%us1Tx~I_o38k*z4DpTs0gmrqqYS-lR%_SVdMKbB``ZcBXw4m@lNPHi)UJ|FLcM+ zUb;ZcA`~c=@{y9+b6fxv7dG)o`G_sFl#Pk1>JYhp`dfnk%L)IMfdub7$Yi$iQjvs6 zJn1is?|7&{WMl%54#0O~#S*NX8$k6xgisxXZ$BZub`Jbn|MptJSxRlGHg{C4#>#*TZEu&5*54gyg9&0Qt^JxW|k!lWaOFojR#8MX1(FI3cm zDuqRy0=@%76fG5%a$}nBBI}PS+{%r2zATBE4ZsbjH`U1U1im*C4`VY?vmPz<=c8=%5yd6g Y*f9EGOxo`. Specifically, the *dipole* angle -style restrains the orientation of a point dipole mu\_j (embedded in atom -'j') with respect to a reference (bond) vector r\_ij = r\_i - r\_j, where 'i' -is another atom of the same molecule (typically, 'i' and 'j' are also -covalently bonded). +style restrains the orientation of a point dipole :math:`\mu_j` (embedded in atom +:math:`j`) with respect to a reference (bond) vector +:math:`\vec{r_{ij}} = \vec{r_i} - \vec{r_j}`, where :math:`i` is another atom of +the same molecule (typically, :math:`i` and :math:`j` are also covalently bonded). -It is convenient to define an angle gamma between the 'free' vector mu\_j -and the reference (bond) vector r\_ij: +It is convenient to define an angle gamma between the 'free' vector :math:`\vec{\mu_j}` +and the reference (bond) vector :math:`\vec{r_{ij}}`: + +.. math:: + + \cos\gamma = \frac{\vec{\mu_j}\cdot\vec{r_{ij}}}{\mu_j\,r_{ij}} -.. image:: Eqs/angle_dipole_gamma.jpg - :align: center The *dipole* angle style uses the potential: -.. image:: Eqs/angle_dipole_potential.jpg - :align: center +.. math:: -where K is a rigidity constant and gamma0 is an equilibrium (reference) + E = K (\cos\gamma - \cos\gamma_0)^2 + + +where :math:`K` is a rigidity constant and gamma0 is an equilibrium (reference) angle. The torque on the dipole can be obtained by differentiating the potential using the 'chain rule' as in appendix C.3 of :ref:`(Allen) `: -.. image:: Eqs/angle_dipole_torque.jpg - :align: center +.. math:: -Example: if gamma0 is set to 0 degrees, the torque generated by + \vec{T_j} = \frac{2K(\cos\gamma - \cos\gamma_0)}{\mu_j\,r_{ij}}\, \vec{r_{ij}} \times \vec{\mu_j} + + +Example: if :math:`\gamma_0` is set to 0 degrees, the torque generated by the potential will tend to align the dipole along the reference -direction defined by the (bond) vector r\_ij (in other words, mu\_j is -restrained to point towards atom 'i'). +direction defined by the (bond) vector :math:`\vec{r_{ij}}` (in other words, :math:`\vec{\mu_j}` is +restrained to point towards atom :math:`i`). -The dipolar torque T\_j must be counterbalanced in order to conserve +The dipolar torque :math:`\vec{T_j}` must be counterbalanced in order to conserve the local angular momentum. This is achieved via an additional force -couple generating a torque equivalent to the opposite of T\_j: +couple generating a torque equivalent to the opposite of :math:`\vec{T_j}`: -.. image:: Eqs/angle_dipole_couple.jpg - :align: center +.. math:: -where F\_i and F\_j are applied on atoms i and j, respectively. + -\vec{T_j} & = & \vec{r_{ij}} \times \vec{F_i}\\ + \vec{F_j} & = & -\vec{F_i} \\ + + +where :math:`\vec{F_i}` and :math:`\vec{F_j}` are applied on atoms :math:`i` +and :math:`j`, respectively. The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) -* gamma0 (degrees) +* :math:`K` (energy) +* :math:`\gamma_0` (degrees) ---------- @@ -108,17 +118,17 @@ page for more info. .. note:: - In the "Angles" section of the data file, the atom ID 'j' + In the "Angles" section of the data file, the atom ID :math:`j` defining the direction of the dipole vector to restrain must come - before the atom ID of the reference atom 'i'. A third atom ID 'k' must + before the atom ID of the reference atom :math:`i`. A third atom ID :math:`k` must also be provided to comply with the requirement of a valid angle - definition. This atom ID k should be chosen to be that of an atom - bonded to atom 'i' to avoid errors with "lost angle atoms" when running + definition. This atom ID :math:`k` should be chosen to be that of an atom + bonded to atom :math:`i` to avoid errors with "lost angle atoms" when running in parallel. Since the LAMMPS code checks for valid angle definitions, - cannot use the same atom ID of either 'i' or 'j' (this was allowed + cannot use the same atom ID of either :math:`i` or :math:`j` (this was allowed and recommended with older LAMMPS versions). -The "newton" command for intramolecular interactions must be "on" +The :doc:`newton ` command for intramolecular interactions must be "on" (which is the default except when using some accelerator packages). This angle style should not be used with SHAKE. @@ -147,8 +157,3 @@ lipid membranes, PloS ONE 6(12): e28637, 2011. **(Allen)** Allen & Tildesley, Computer Simulation of Liquids, Clarendon Press, Oxford, 1987. - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_dipole.txt b/doc/txt/angle_dipole.txt deleted file mode 100644 index cdb11972ec..0000000000 --- a/doc/txt/angle_dipole.txt +++ /dev/null @@ -1,126 +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 - -angle_style dipole command :h3 -angle_style dipole/omp command :h3 - -[Syntax:] - -angle_style dipole :pre - -[Examples:] - -angle_style dipole -angle_coeff 6 2.1 180.0 :pre - -[Description:] - -The {dipole} angle style is used to control the orientation of a dipolar -atom within a molecule "(Orsi)"_#Orsi. Specifically, the {dipole} angle -style restrains the orientation of a point dipole mu_j (embedded in atom -'j') with respect to a reference (bond) vector r_ij = r_i - r_j, where 'i' -is another atom of the same molecule (typically, 'i' and 'j' are also -covalently bonded). - -It is convenient to define an angle gamma between the 'free' vector mu_j -and the reference (bond) vector r_ij: - -:c,image(Eqs/angle_dipole_gamma.jpg) - -The {dipole} angle style uses the potential: - -:c,image(Eqs/angle_dipole_potential.jpg) - -where K is a rigidity constant and gamma0 is an equilibrium (reference) -angle. - -The torque on the dipole can be obtained by differentiating the -potential using the 'chain rule' as in appendix C.3 of -"(Allen)"_#Allen1: - -:c,image(Eqs/angle_dipole_torque.jpg) - -Example: if gamma0 is set to 0 degrees, the torque generated by -the potential will tend to align the dipole along the reference -direction defined by the (bond) vector r_ij (in other words, mu_j is -restrained to point towards atom 'i'). - -The dipolar torque T_j must be counterbalanced in order to conserve -the local angular momentum. This is achieved via an additional force -couple generating a torque equivalent to the opposite of T_j: - -:c,image(Eqs/angle_dipole_couple.jpg) - -where F_i and F_j are applied on atoms i and j, respectively. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) -gamma0 (degrees) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER-MISC package. See the "Build package"_Build_package.html doc -page for more info. - -NOTE: In the "Angles" section of the data file, the atom ID 'j' -defining the direction of the dipole vector to restrain must come -before the atom ID of the reference atom 'i'. A third atom ID 'k' must -also be provided to comply with the requirement of a valid angle -definition. This atom ID k should be chosen to be that of an atom -bonded to atom 'i' to avoid errors with "lost angle atoms" when running -in parallel. Since the LAMMPS code checks for valid angle definitions, -cannot use the same atom ID of either 'i' or 'j' (this was allowed -and recommended with older LAMMPS versions). - -The "newton" command for intramolecular interactions must be "on" -(which is the default except when using some accelerator packages). - -This angle style should not be used with SHAKE. - -[Related commands:] - -"angle_coeff"_angle_coeff.html, "angle_hybrid"_angle_hybrid.html - -[Default:] none - -:line - -:link(Orsi) -[(Orsi)] Orsi & Essex, The ELBA force field for coarse-grain modeling of -lipid membranes, PloS ONE 6(12): e28637, 2011. - -:link(Allen1) -[(Allen)] Allen & Tildesley, Computer Simulation of Liquids, -Clarendon Press, Oxford, 1987. From 36a5c73a71ac7d24a013460bb7d867f4f5080282 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 20:49:02 -0500 Subject: [PATCH 414/557] Update docs: angle_fourier --- doc/src/Eqs/angle_fourier.jpg | Bin 4618 -> 0 bytes doc/src/Eqs/angle_fourier.tex | 9 ----- doc/src/angle_fourier.rst | 37 +++++++++--------- doc/txt/angle_fourier.txt | 71 ---------------------------------- 4 files changed, 18 insertions(+), 99 deletions(-) delete mode 100644 doc/src/Eqs/angle_fourier.jpg delete mode 100644 doc/src/Eqs/angle_fourier.tex delete mode 100644 doc/txt/angle_fourier.txt diff --git a/doc/src/Eqs/angle_fourier.jpg b/doc/src/Eqs/angle_fourier.jpg deleted file mode 100644 index e748e67430c11709df92ac52bf1474f6406f6757..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 4618 zcmbtY^;;8;x87($5k@I7LZ*xo`M^Nw5Vj#TdLu+yO1cq2N_zAM6p)Q{fG}E+P6edL z2qmQjk&wE4?{n`zaPK+K^Zs(`m-jj6Iq&84<#zxRQUjp@00Myk_>}`L$pAF~H6;}l z6(#i*P*YRW&|asby|SAO4A-tR-voh}Z!$Bpuyb>;uyV37GvDIB#mU3N%gf8cAs{FK z7UTx=f-lm7Uwz=jN9Jf%y`Zp=z7f*4rHROp`f7+nm9j+>!_Aqwh9{u+ zWopf89|}8FlQ%%A#YU^6&97z%Ufl1$#*&#I?eW9+-d@*89JA|Pk*};C(=Pr}o0ois z7@?YQHlsn8lr_pl5VD}U|L~Zw3jgSxs(~UL%l`zsUYxt>>eMj!`XrX~*T8<&HbPeg z{^`T;ZhkNvP-#zo%L_Ill>Fb94z;<{BxiU4y3jS9Rq)_oTed;{MPHQ*n_V%1N1P;ezvj zZV+V3WgHGSVVNO_%Jd4(@0gzV-}uKXqI)^&s6*X>KEe$Lz9>bp%B>?5y9MW`axPC8^T@xt$iM*;cOvafv>f9SPBC($!aIux0PW;+YQ{aLE)X z#_?L#0>uq3HVQYRkQxlQWjU);Pjri~5z;qyaaY~A*GG0qrAij(Qr?N~1BXqtGQV_( zb`i4gFoR>kYdn&L#KXp8tsRna%QXaID#RV5SnGvEr9bv=mCY?>N%_t%wv-YiX*>$~ms zxSFl21uwtRujK}*ez#R>6K*u<@bvYbeA)g=u;)~oa=kgz=u->W7bxY^A|wjWp4mEY z3wbOURG@qWoxT2UH%?hP6ztkohlj@7d~R z2TO#qc%R@~7kdstvd7lp(z}bHM#aRQSkU~KgzOpYO%BwAPc_!K{b>Hk=qL`qAvjD! z^Wg5{FjKItmfgqC85#M{d8bG+e{aZKSaV$h0vl_PIpVwtiqk8#JL>)-K8!rUhvAR4 zD+jaK?LzAhI!i-LdtKrh;Z0V8v+{nyvDz)^_%xbBB_t7+$#DUn^7;%tza4#!IuD18 z4y~thE|1>5rX`*#}t-Z(Dwgo!{=5eyz zC?-psUc2xo`%aYX|@>5?QiJ} zOY6CvC}0<$d_o_EgS2IV2l9sb-p)5(t(mIbHqqk=deDnekB=2 zi3pUh!l>rQiWG-t^sdAOY}hl}c_a9dl+_%+iBmSuds4>I zVQv{&+)&n+E6!T{QPDWA`aSES;dgJU4^U2kY|49;xt`#I*lZc?51wOPTFt_?U8gLZ zcPj8ojl0*ZM#}Eva!IKx)(T1y%wCL|fsESm>3AA-q1e57=jS6pbr|DtQE!WSt9j*Z zj!_JN_}M;iQWSQYu!=HICVxuad`VB*XQ`B&+T7g!>1^?@$oEGrVY-fc=D%MMTPj;4 zH6=AJ0u3z}#5Gr)y?+xV2Id30q{f_t(UbY0v{%&##qdTy^zRP>4jMI%DgSW$sz>jw zZxhE%V21VVB|Ct$Faj0<0Agrr&X}h_V`g=*+7GYs&?X6F>;b^@4*}xgUTBkOFY~0n z>`3YuTTw6LTGy&}#yQ7ht~VpI-XAnp@o~8r=A@8 z{1y9V{B)PRj|}{QVFxCvlOX`g_c|=<^nCxVlOoPrIcNeqv&8oU=*#zVUHJOTyiQ8Ru6-Ye*<;Sj9 zH8va~c`1Jc&SR$Yo^iW)lw1PLv@n(;iHd&>iBi+kNL4)`DoHFI0Qe@Y7POI@>+`8& z!cX02?m=F7fakx7)q}}6!Zpb_mB&^E>qliWn<-ymk4O;>wJvu$Vn^=8N+i*|KrHY741EG-@ zwLhiENoUIN>Q7w0zuW=+^#aW93MwgdqG-eG2+C2BcJNnRayvcm2e+9E9)P46it@2}6jjL7}kexK3Im0jj3nWWwT`2n3$@fc0z6BMkIO(1d{}bOU>~rvjcC zmda$z($S4;eQ78e5j>B|MfxpFVJ-nasuz@`m&2a!fB#*&1k6{sO!iG?*^8RkH;~LM zSH1?K4qsYKK+)UlEk?9PINQSOjcr|9s0u%)5vyk+39X&lJwEWo$Odz?P95PywY7h~ z?uPQZqP)jN{EUa$;We==_IA*ddubi%5OXECCI@SR*kkl^!RCU|;{!+Hs(%sZ2N~h2 zfmrrA{!2iaUE_o3Ms<;8vd#-LJrDVq1Lz3PIkl7hOL6wkq|(om&n6(%-9c@Ekywju zm}aHvsy07Mo;_DWtc1M>orgI$N-aT@s(j!*u7np#YoqhC$@T}c9oiNx#vP6;Lg(Bc z1Z=@TkwTDK-(^Ezjj=BG1n7T^NziGW$qJ1X<>~aqd5hGaYEwWQ!Syhc{DKy&4yR7aX z8LP3++W&YS(2hqm9rM>IIz+fZb%fljHLyO1-3C74Qy}ul^#LxZINkKu!MKWb9jL}X zpC)yhOVzQ3JBX9Xq0WmtuP(kUTnJQUoLTP1`nU@YY#SemPv+uF2C{iFF=~4d32YcK znl-JoHb3E{k(#kBf;671aq=%(%mhZZXItzJO$w-e9AfhZI~1NB;Is@h75CFQ#^zao zLVa$6n|*G>xTKmza}O?utheIu z3%NMC(rY&LA^SSs<1A(TwCI6&IxSjHMdO&7NzuUx^jiqzLRnPrG&&(>ESD-#0m?iY z6Oddyex0Y?T8B_dK(Dc1t6Vz{wWg=cWU*x_Z05n&Wl{(dQx@-ap-^xGIF$>JXr3!? zFxRaV`qQAnU6q=URxu*sntUpwh;oz-?lh$qs_rX-uARPHu%aDTY+BVP2G$trB7aH% zf8BTffu=o~|7YeBU|g9@n6vr&ot)%t^3bVhd?~J1{F*8VX86QG>gw`W;XS`l3(kg6)Qx&HE6|SH+in^8{4W<_P${ z<7f+d;|`OSW7h=7b&GHW;lk-@Z2B{q;OCwhF;j4zE+5BJxK<2wS&6wNX`p(VCE#rw zMcrcRhj)-sGIMi~A8f&~(;JrjT2aN+J3tx2tvJ~x7*IZR^)T&;m)V|ZS2NT*+v|-R z4OnM#seQAPh?ME0{cl=?2b1Y_pQ>ydoPh?>efx>|9T7au+bgHGrWsSVg8r~WUiTix z2G~1i760US%8Yz$JUcz42n_RhxiQAB^WW}w@n52LZt{ytm6mw$LGb*MLie>sPejyT z0Nfo60)3Opes3Li?WXIRXMgIU{b&HXQ%Ab9R$SO}32^VIX(V)(?l=hh^1_#vVL{FX z#4%>rqe*-9H~Y|p^^KRYb5}G zKR^%f3ECQp(2wRWPmR+@K=;h`uDDI1m(r4M z==Q1Zp7)Hsd}{qZ?KDv`EU3KKN9aY;YVD%v1)cPrl9xR@xuK&9=cyiqxBv4yf3@`3 z#KkX?Q!(Nri)T{ztd+p(Yzm8YO9auhQt`s@&yNYo1q)-fPEJN9!MBCKL`^B#KY1a%4ClaIpD3!uPjk2Yq zNLVy4(ULRZSdyt|!LCtUl1CMb!ijXEkXRKy+@bW{3HJn-@ECoD3kDm+O}NJjaDTa4 z=W_@W57l>P|LGTGSZ>k&`ZLG?X}8)xC0OE^kht`lr#rZ&CzWxg%gihD;c9AIADY7W zJMBk3ohglbJC#*-&6v?%*NARmDjqxnvGWjOOvD>0*{SDZ6;?4TyAiI4*S$Ra=^vQt zUz*t|>IHcq^mrY2TF;X##7VwN-WD@l#$?fnuj(q)kJro%&6p1?_xxXPs2G1zI8j~* QnaueAs2x|eR+psz0w8OqE&u=k diff --git a/doc/src/Eqs/angle_fourier.tex b/doc/src/Eqs/angle_fourier.tex deleted file mode 100644 index f7f76462e3..0000000000 --- a/doc/src/Eqs/angle_fourier.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K [C_0 + C_1 \cos ( \theta) + C_2 \cos( 2 \theta) ] -$$ - -\end{document} diff --git a/doc/src/angle_fourier.rst b/doc/src/angle_fourier.rst index c974081d92..c814b7224e 100644 --- a/doc/src/angle_fourier.rst +++ b/doc/src/angle_fourier.rst @@ -1,42 +1,46 @@ -.. index:: angle\_style fourier +.. index:: angle_style fourier -angle\_style fourier command -============================ +angle_style fourier command +=========================== -angle\_style fourier/omp command -================================ +angle_style fourier/omp command +=============================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style fourier Examples """""""" -angle\_style fourier -angle\_coeff 75.0 1.0 1.0 1.0 +.. code-block:: LAMMPS + + angle_style fourier + angle_coeff 75.0 1.0 1.0 1.0 Description """"""""""" The *fourier* angle style uses the potential -.. image:: Eqs/angle_fourier.jpg - :align: center +.. math:: + + E = K [C_0 + C_1 \cos ( \theta) + C_2 \cos( 2 \theta) ] + The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) -* C0 (real) -* C1 (real) -* C2 (real) +* :math:`K` (energy) +* :math:`C_0` (real) +* :math:`C_1` (real) +* :math:`C_2` (real) ---------- @@ -78,8 +82,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_fourier.txt b/doc/txt/angle_fourier.txt deleted file mode 100644 index 7dc9975793..0000000000 --- a/doc/txt/angle_fourier.txt +++ /dev/null @@ -1,71 +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 - -angle_style fourier command :h3 -angle_style fourier/omp command :h3 - -[Syntax:] - -angle_style fourier :pre - -[Examples:] - -angle_style fourier -angle_coeff 75.0 1.0 1.0 1.0 - -[Description:] - -The {fourier} angle style uses the potential - -:c,image(Eqs/angle_fourier.jpg) - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) -C0 (real) -C1 (real) -C2 (real) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER_MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From 46db670093b327bce7dc61fa9e88add10fce0c84 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 20:52:55 -0500 Subject: [PATCH 415/557] Update docs: angle_fourier_simple --- doc/src/Eqs/angle_fourier_simple.jpg | Bin 2761 -> 0 bytes doc/src/Eqs/angle_fourier_simple.tex | 9 ---- doc/src/angle_fourier_simple.rst | 35 +++++++------- doc/txt/angle_fourier_simple.txt | 70 --------------------------- 4 files changed, 17 insertions(+), 97 deletions(-) delete mode 100644 doc/src/Eqs/angle_fourier_simple.jpg delete mode 100644 doc/src/Eqs/angle_fourier_simple.tex delete mode 100644 doc/txt/angle_fourier_simple.txt diff --git a/doc/src/Eqs/angle_fourier_simple.jpg b/doc/src/Eqs/angle_fourier_simple.jpg deleted file mode 100644 index 6c9297b970e008bf50f77649e564783ec31c8d34..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2761 zcma);c{J1u8^?bWW2?bTQnq0*Wo$(uAsI_!>}0}B*S$m+gBe>WLY6_-~%7Zqj;k zpqN5fSziC}OK-iJ1(|vq%Q)XQab=(t|0UtU>9JnMQ#r3JK;hM95KH%;SMvQ*pAjBc0slAo34e||MnBJOPHDMX9} zF1s}v5pU}M+T^hOC0nYCO@+p$axctNFb>jhmgaFXu)oqppWjgk(tzj_!hny&umFXbQGdi{6c zgT>H^x>J?xKDVQHSwh3#%UKB?JdtI!Q& zEC-**<(P~_54CsS4v80?(K3w$i`2~ro~}2Hyq@wE1wN{=^7j)FeugS*%e7+E7V`tag?@*Y$FGngxe4y|HAE3k!yi`)C zCj1y!-v#Z`j_)2wdwAW$Juoy{F8}>ZkNHYDULvki)RCB!AO&-fr1ODv{Px%rcZc3L zFK1hu_5KL-H#fAp7}&rBghTtTG}o&FSD zRE=w%{4<_gNOE+jJUSZl5LZ*@Ryo|XmZ|%MQ}INaXmjA(bo<0BDj7OfQKjf5B2;^! z#&Wtk0way@ILCn@-H3gD)KE0XMt(H1782s9jZ$AJ6gO_p!p84o#dN$Qx_x<+yr2Ws z%2p|m==h|Bs5f8+T-y$~yfMZF$?$OC+nf=)YeD*2u4PM1ZGX?ha6ff4Zrll_Dq+@W z@Ktn)Ug0xX9QD*=dFOI^TmD^vlSSr~zz0QBhd+VUe%u#zwg$-Zaq7ZNk^L`tueHdR zp9Pt(%n;r)ltF6dBO`&@sQ!yhWNWMk*@BmlyI|a0xaq!vI;iW86K%F8sSZ%ycOD8t z5TE8%TZ6=`CzMKfYRB;KlEsp3^lY0|=geY}{iP)s)z9BFS@YsWncU1AjGukPLd%7i z`BxL{YvC-VP{kDg*0#_SGEc00&ccf*-27Z)R~812#=6pgidk4BJO6kA{&)n3-FIqD z!0Xg={Uv8&Y9pePUX9YTC^P1|7)I# zFe?_(EK>Kt%Qro)8>1J%Z>0X>QcmBVg1pt}q&>XubB<&UK_a^qNENv>h_C`F!R+kK zYqbjbJ+`GKv?>GwVdLbSky3q({mcK%c0YRM-cH6`Kmu@9tsp4G;kX@nYV~@|ud5v& zik3UQUhsh@4aGlW_`vQ^Zo}gkAMx~=A&#C!rbtg*>ob*(A7JBe$Aj$x<~>8?7N`m> za!DI=;v6YBVnRC+tYNWi&j(C8@pp zQn*<&LBK~P!A!(-J^JGD?lJ3tCX?*2lF4any9DkE(SEBWl|)b{qtKnhF0mxK(dgUy z+QX-JJG)HTG(PYw+ch&?gIROjypd{~ehasFGLUQQmKGNIqR1L<5sQrNW*l+1OZe<{ zH<~f2a_NuWKzrjVaZxdOm%++3{iyks?M;P;I$X|kt}wRYz^Y=B3DJFNgLhk}=vKv` zX5*arjT9~honH c$jusC$%pvuLDidH%rQCh|ZAl8Y@rBX8qao>XgJZ9NXceoFi~ z)E0c+gEd0?ihDKGjmyb#Y|I1BHwa3`mNR`O1A1zq(Rx&Ce_spQ<4gxK;(hWpit2e% z2F9gNUGapO@Mv1AUg89mtbH^HgT*LmsJ5y_{7BfPY|GAa_ZvhVkw*8Q#k3m+Hv^Pp{KJ$&u?1%@*A;6MntGSAWmO}8 z+InBS-&1DLW|^Z~+?v(<;Pc9^_p>PRYWidFecZS<6?&y5tgenh;co5KUN@%J{ z$lqbk=RSI=mrB5!hJAMoPQ{x%g!|mr+VL*6ABYx{rOf%0oWmYONlW}Sk8xDz*?FFE z32q%FCxVZPSszZ+~bn;nu>5RA^AB7aXzj33rA&g#+g!mT}l>`qa)hPpMyE! z@4ktysRcjvWtPRJSz|jb#cs`sxf;Pwika-ImuJNsg4wu+|I$pJJy#IlFi6&5HnOyNla1FFpZlMDRN7lg zzC=`uq$7?EGjk3IAvT)2R8Iom@jEeY39&SH5Ur940cQn0oc~`(ase znNkAWyON2>b63UC_L)ej@i{ErcPz?Kh5Sfc|KOD` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy) -* c (real) -* n (real) +* :math:`K` (energy) +* :math:`c` (real) +* :math:`n` (real) ---------- @@ -77,8 +81,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_fourier_simple.txt b/doc/txt/angle_fourier_simple.txt deleted file mode 100644 index ae5d308353..0000000000 --- a/doc/txt/angle_fourier_simple.txt +++ /dev/null @@ -1,70 +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 - -angle_style fourier/simple command :h3 -angle_style fourier/simple/omp command :h3 - -[Syntax:] - -angle_style fourier/simple :pre - -[Examples:] - -angle_style fourier/simple -angle_coeff 100.0 -1.0 1.0 - -[Description:] - -The {fourier/simple} angle style uses the potential - -:c,image(Eqs/angle_fourier_simple.jpg) - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy) -c (real) -n (real) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER_MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From dcf332f89659adc05673c585ffae3d2db2076db1 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 20:57:34 -0500 Subject: [PATCH 416/557] Update docs: angle_harmonic --- doc/src/Eqs/angle_harmonic.jpg | Bin 2005 -> 0 bytes doc/src/Eqs/angle_harmonic.tex | 9 ---- doc/src/angle_harmonic.rst | 45 +++++++++---------- doc/txt/angle_harmonic.txt | 77 --------------------------------- 4 files changed, 21 insertions(+), 110 deletions(-) delete mode 100644 doc/src/Eqs/angle_harmonic.jpg delete mode 100644 doc/src/Eqs/angle_harmonic.tex delete mode 100644 doc/txt/angle_harmonic.txt diff --git a/doc/src/Eqs/angle_harmonic.jpg b/doc/src/Eqs/angle_harmonic.jpg deleted file mode 100644 index 352be0b5440fac4e5f896212eca6a2dc6ccfd02f..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2005 zcmZ`)dpOgJAO7xUB4(Qr#)Q?j4jmDiIvXq5Rya$B={PRsPOc?X*1=G6+4z+@40EcJ zJ43Ef$fVqgsg&znBA1ktetypR;o_&apAgOE zuQM{%ch;@2YOnNXMqN?Zj$gsd(!~1UndyU3TG(FlT$@A2s=*pKeaa>mQ|~Zovd8k8 zZ=@(eNSl_I1x!yIIM@tXEk5+2(*xGY?mpd}@g|)tQ?3!@Xhj#12a-c;iinEzVTU7D z@E$fLoLA{Jx}3YvKn#{-ytoNVJ8M`Un!Q2vuIqnE#`qE-i%VX2VuoJcXY_?C&wwRd z_Yk&i4?QX5>RPQ!9LV;(8Mm2*h~uZ_ktcpn`}AqwUb*sNbDIiD8tvj_WFWu1-pCT) zHY<(U0?ef1-?+fmn-?Ep=2#p#tdVQ)4Y*{?GQD z@a|t3E&QZQj(ceDYy|Y26Y*DSb5lD59_L!%=Lw*V1v2(RehQ@l8*|~UeH`kg4j7)(GU59W< zcSuoFadCE~Z$Xk9QmfaNODj3Lc3JGZd^Sim$V>~~3hu=Se&E>~M2 zH0N$y6(+IsyoLf5h$6BYG6U8GM8=fOh8Ah!;r!8C&kvq$o2abS_VK|9+C8F+<$o&PH-p4f4oy7@H5*y5lc)pMSdV zR;t0;At2;^GQNCH>l;^nLKk5mJm_r4ShT+_opSr}dMl3&O?8Vl%h{Fkm}FS$C1G2a zOS2v1zg(CutQaOTCf;SQXlJ!sT=X_?B-Y2xVFa0oMt;f5TFlxGE9m-{=4EyucPL?4 zpL0MlUp!JUAvv``cc#&O)v(^&0`t=2n3p<5%AYISjZlkUSJjh!PgzGh@;(x=4}uc3 zt5p#W1!=7O7{a}1_N@r@8QNLn1vSn9FZ?p5Z@gc{G^!|lpeaVlH!k);)q-M~Y#?b1 zs1|H01uts_4x8w>-LcoG6rPk>24tUc?d^P&?^Pq5Y04A11n@q&LJv2j#@demz`rCh ze8;Kcm{q#&NE~L|v0W&sE3kefTXHQcg?0HTj;95+!LdO|mn)-UwYIB+ba=2Se?#ug z5%@;(pI3@ZnBiO(|8&8=R&o7qD}8TKiA71=U-Xg-MQg{6HsxBL@@AEuAt9yto5nrG z%m-s#=DqX{rz)OBP!|40=n1KkhgbG*^zzX{q|Jnf_d$s1YD6#Xzte}~T&;54wQbTR_*Br^Kiv*#uexcXpl~_HvUF!75SH-`Y z#boc;fV4&Jz0|Ps-o9ZB-@&lH8%YYhUyaHHGcyqmps65TWC79gzkT3SDY)h6mM?z= ze`m0&a{?)-hF-UMv7uKT(-~y{?CL-%0VJ#;8r)SDpf?V;Qd+;hSjeWVI{gZ0LZ~eM zz1N(`=6O(;x~;Jf?ZPkmC|Blu3Gvw@^GmU)@+0| z&?Mu>S2zoJp8gFnXPleT-!z8cUiHW|hM;3+W~Qd6$IdLplsuGG%vfJm6=$wRE8YKt z!#*pd9mUmg{TsMcfufd$U^WL|EFDfvM&uLG1u~HcU4jWyK3(*Anogc#(Z^gris#+J zHAlcds4-F`p(9K`5?QOCswE?TA0qKZR%$WS2CcdptM%li{X=~dv4>l9>YH`$ev2rP zbGiOJC)aBvA-}_Mp2_lj^d!l#ALsFjE9~XpOTY&SX>WDEwHH6u@pLi|^^L~Nh5u3$ z*64<#`ekj7Y!4Yz@o|`f=~cdVX%xxc{QM@~Iw`8a#nU a-AI(ug09UxYtH>s``_E`pW1WZ8u=fX(30Q) diff --git a/doc/src/Eqs/angle_harmonic.tex b/doc/src/Eqs/angle_harmonic.tex deleted file mode 100644 index c566376b5b..0000000000 --- a/doc/src/Eqs/angle_harmonic.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K (\theta - \theta_0)^2 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/angle_harmonic.rst b/doc/src/angle_harmonic.rst index 87b71ad9ad..1066621729 100644 --- a/doc/src/angle_harmonic.rst +++ b/doc/src/angle_harmonic.rst @@ -1,22 +1,22 @@ -.. index:: angle\_style harmonic +.. index:: angle_style harmonic -angle\_style harmonic command -============================= +angle_style harmonic command +============================ -angle\_style harmonic/intel command -=================================== +angle_style harmonic/intel command +================================== -angle\_style harmonic/kk command +angle_style harmonic/kk command +=============================== + +angle_style harmonic/omp command ================================ -angle\_style harmonic/omp command -================================= - Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style harmonic @@ -24,7 +24,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style harmonic angle_coeff 1 300.0 107.0 @@ -34,22 +34,24 @@ Description The *harmonic* angle style uses the potential -.. image:: Eqs/angle_harmonic.jpg - :align: center +.. math:: -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. + E = K (\theta - \theta_0)^2 + + +where :math:`\theta_0` is the equilibrium value of the angle, and :math:`K` is a +prefactor. Note that the usual 1/2 factor is included in :math:`K`. The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/radian\^2) -* theta0 (degrees) +* :math:`K` (energy/radian\^2) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian\^2. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K` are in energy/radian\^2. ---------- @@ -91,8 +93,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_harmonic.txt b/doc/txt/angle_harmonic.txt deleted file mode 100644 index b632f68478..0000000000 --- a/doc/txt/angle_harmonic.txt +++ /dev/null @@ -1,77 +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 - -angle_style harmonic command :h3 -angle_style harmonic/intel command :h3 -angle_style harmonic/kk command :h3 -angle_style harmonic/omp command :h3 - -[Syntax:] - -angle_style harmonic :pre - -[Examples:] - -angle_style harmonic -angle_coeff 1 300.0 107.0 :pre - -[Description:] - -The {harmonic} angle style uses the potential - -:c,image(Eqs/angle_harmonic.jpg) - -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/radian^2) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian^2. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From aed67fc96e5a190932244c618b7f8ef96d6c2323 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 21:06:14 -0500 Subject: [PATCH 417/557] Update docs: angle_hybrid --- doc/src/angle_hybrid.rst | 35 +++++++--------- doc/txt/angle_hybrid.txt | 91 ---------------------------------------- 2 files changed, 15 insertions(+), 111 deletions(-) delete mode 100644 doc/txt/angle_hybrid.txt diff --git a/doc/src/angle_hybrid.rst b/doc/src/angle_hybrid.rst index e31df56e72..f685beacc8 100644 --- a/doc/src/angle_hybrid.rst +++ b/doc/src/angle_hybrid.rst @@ -1,13 +1,13 @@ -.. index:: angle\_style hybrid +.. index:: angle_style hybrid -angle\_style hybrid command -=========================== +angle_style hybrid command +========================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style hybrid style1 style2 ... @@ -17,11 +17,11 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style hybrid harmonic cosine angle_coeff 1 harmonic 80.0 30.0 - angle_coeff 2\* cosine 50.0 + angle_coeff 2* cosine 50.0 Description """"""""""" @@ -31,19 +31,19 @@ simulation. An angle style is assigned to each angle type. For example, angles in a polymer flow (of angle type 1) could be computed with a *harmonic* potential and angles in the wall boundary (of angle type 2) could be computed with a *cosine* potential. The assignment -of angle type to style is made via the :doc:`angle\_coeff ` +of angle type to style is made via the :doc:`angle_coeff ` command or in the data file. -In the angle\_coeff commands, the name of an angle style must be added +In the :doc:`angle_coeff ` commands, the name of an angle style must be added after the angle type, with the remaining coefficients being those appropriate to that style. In the example above, the 2 angle\_coeff commands set angles of angle type 1 to be computed with a *harmonic* -potential with coefficients 80.0, 30.0 for K, theta0. All other angle -types (2-N) are computed with a *cosine* potential with coefficient -50.0 for K. +potential with coefficients 80.0, 30.0 for :math:`K`, :math:`\theta_0`. All other angle +types :math:`(2 - N)` are computed with a *cosine* potential with coefficient +50.0 for :math:`K`. If angle coefficients are specified in the data file read via the -:doc:`read\_data ` command, then the same rule applies. +:doc:`read_data ` command, then the same rule applies. E.g. "harmonic" or "cosine", must be added after the angle type, for each line in the "Angle Coeffs" section, e.g. @@ -77,7 +77,7 @@ input script, since BondBond (or BondAngle) coefficients need not be specified at all for angle types that are not *class2*\ . An angle style of *none* with no additional coefficients can be used -in place of an angle style, either in a input script angle\_coeff +in place of an angle style, either in a input script :doc:`angle_coeff ` command or in the data file, if you desire to turn off interactions for specific angle types. @@ -95,16 +95,11 @@ for more info. Unlike other angle styles, the hybrid angle style does not store angle coefficient info for individual sub-styles in a :doc:`binary restart files `. Thus when restarting a simulation from a restart -file, you need to re-specify angle\_coeff commands. +file, you need to re-specify :doc:`angle_coeff ` commands. Related commands """""""""""""""" -:doc:`angle\_coeff ` +:doc:`angle_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_hybrid.txt b/doc/txt/angle_hybrid.txt deleted file mode 100644 index 0046c161be..0000000000 --- a/doc/txt/angle_hybrid.txt +++ /dev/null @@ -1,91 +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 - -angle_style hybrid command :h3 - -[Syntax:] - -angle_style hybrid style1 style2 ... :pre - -style1,style2 = list of one or more angle styles :ul - -[Examples:] - -angle_style hybrid harmonic cosine -angle_coeff 1 harmonic 80.0 30.0 -angle_coeff 2* cosine 50.0 :pre - -[Description:] - -The {hybrid} style enables the use of multiple angle styles in one -simulation. An angle style is assigned to each angle type. For -example, angles in a polymer flow (of angle type 1) could be computed -with a {harmonic} potential and angles in the wall boundary (of angle -type 2) could be computed with a {cosine} potential. The assignment -of angle type to style is made via the "angle_coeff"_angle_coeff.html -command or in the data file. - -In the angle_coeff commands, the name of an angle style must be added -after the angle type, with the remaining coefficients being those -appropriate to that style. In the example above, the 2 angle_coeff -commands set angles of angle type 1 to be computed with a {harmonic} -potential with coefficients 80.0, 30.0 for K, theta0. All other angle -types (2-N) are computed with a {cosine} potential with coefficient -50.0 for K. - -If angle coefficients are specified in the data file read via the -"read_data"_read_data.html command, then the same rule applies. -E.g. "harmonic" or "cosine", must be added after the angle type, for each -line in the "Angle Coeffs" section, e.g. - -Angle Coeffs :pre - -1 harmonic 80.0 30.0 -2 cosine 50.0 -... :pre - -If {class2} is one of the angle hybrid styles, the same rule holds for -specifying additional BondBond (and BondAngle) coefficients either via -the input script or in the data file. I.e. {class2} must be added to -each line after the angle type. For lines in the BondBond (or -BondAngle) section of the data file for angle types that are not -{class2}, you must use an angle style of {skip} as a placeholder, e.g. - -BondBond Coeffs :pre - -1 skip -2 class2 3.6512 1.0119 1.0119 -... :pre - -Note that it is not necessary to use the angle style {skip} in the -input script, since BondBond (or BondAngle) coefficients need not be -specified at all for angle types that are not {class2}. - -An angle style of {none} with no additional coefficients can be used -in place of an angle style, either in a input script angle_coeff -command or in the data file, if you desire to turn off interactions -for specific angle types. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -Unlike other angle styles, the hybrid angle style does not store angle -coefficient info for individual sub-styles in a "binary restart -files"_restart.html. Thus when restarting a simulation from a restart -file, you need to re-specify angle_coeff commands. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From c182d3f545d0de9eba2932e8cb960ad83c2457e0 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Thu, 14 Nov 2019 21:15:55 -0500 Subject: [PATCH 418/557] Update docs: fix_restrain --- doc/src/fix_restrain.rst | 58 +++++------ doc/txt/fix_restrain.txt | 209 --------------------------------------- 2 files changed, 29 insertions(+), 238 deletions(-) delete mode 100644 doc/txt/fix_restrain.txt diff --git a/doc/src/fix_restrain.rst b/doc/src/fix_restrain.rst index 0276194bd2..0fc0ccee77 100644 --- a/doc/src/fix_restrain.rst +++ b/doc/src/fix_restrain.rst @@ -7,7 +7,7 @@ Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS fix ID group-ID restrain keyword args ... @@ -39,7 +39,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS fix holdem all restrain bond 45 48 2000.0 2000.0 2.75 fix holdem all restrain dihedral 1 2 3 4 2000.0 2000.0 120.0 @@ -98,7 +98,7 @@ conventional force field terms. If the restraint is applied during a dynamics run (as opposed to during an energy minimization), a large restraint coefficient can significantly reduce the stable timestep size, especially if the atoms are initially far from the preferred -conformation. You may need to experiment to determine what value of K +conformation. You may need to experiment to determine what value of :math:`K` works best for a given application. For the case of finding a minimum energy structure for a single @@ -107,7 +107,7 @@ parameters or constructing a potential energy surface), commands such as the following may be useful: -.. parsed-literal:: +.. code-block:: LAMMPS # minimize molecule energy with restraints velocity all create 600.0 8675309 mom yes rot yes dist gaussian @@ -134,16 +134,18 @@ The *bond* keyword applies a bond restraint to the specified atoms using the same functional form used by the :doc:`bond\_style harmonic ` command. The potential associated with the restraint is -.. image:: Eqs/bond_harmonic.jpg - :align: center +.. math:: + + E = K (r - r_0)^2 + with the following coefficients: -* K (energy/distance\^2) -* r0 (distance) +* :math:`K` (energy/distance\^2) +* :math:`r_0` (distance) -K and r0 are specified with the fix. Note that the usual 1/2 factor -is included in K. +:math:`K` and :math:`r_0` are specified with the fix. Note that the usual 1/2 factor +is included in :math:`K`. ---------- @@ -153,16 +155,17 @@ The *angle* keyword applies an angle restraint to the specified atoms using the same functional form used by the :doc:`angle\_style harmonic ` command. The potential associated with the restraint is -.. image:: Eqs/angle_harmonic.jpg - :align: center +.. math:: + + E = K (\theta - \theta_0)^2 with the following coefficients: -* K (energy/radian\^2) -* theta0 (degrees) +* :math:`K` (energy/radian\^2) +* :math:`\theta_0` (degrees) -K and theta0 are specified with the fix. Note that the usual 1/2 -factor is included in K. +:math:`K` and :math:`\theta_0` are specified with the fix. Note that the usual 1/2 +factor is included in :math:`K`. ---------- @@ -173,20 +176,22 @@ atoms using a simplified form of the function used by the :doc:`dihedral\_style charmm ` command. The potential associated with the restraint is -.. image:: Eqs/dihedral_charmm.jpg - :align: center +.. math:: + + E = K [ 1 + \cos (n \phi - d) ] + with the following coefficients: -* K (energy) -* n (multiplicity, >= 0) -* d (degrees) = phi0 + 180 +* :math:`K` (energy) +* :math:`n` (multiplicity, >= 0) +* :math:`d` (degrees) = :math:`\phi_0 + 180` -K and phi0 are specified with the fix. Note that the value of the -dihedral multiplicity *n* is set by default to 1. You can use the +:math:`K` and :math:`\phi_0` are specified with the fix. Note that the value of the +dihedral multiplicity :math:`n` is set by default to 1. You can use the optional *mult* keyword to set it to a different positive integer. Also note that the energy will be a minimum when the -current dihedral angle phi is equal to phi0. +current dihedral angle :math:`\phi` is equal to :math:`\phi_0`. ---------- @@ -233,8 +238,3 @@ Restrictions **Related commands:** none **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/fix_restrain.txt b/doc/txt/fix_restrain.txt deleted file mode 100644 index 8e962f4cc9..0000000000 --- a/doc/txt/fix_restrain.txt +++ /dev/null @@ -1,209 +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 - -fix restrain command :h3 - -[Syntax:] - -fix ID group-ID restrain keyword args ... :pre - -ID, group-ID are documented in "fix"_fix.html command :ulb,l -restrain = style name of this fix command :l -one or more keyword/arg pairs may be appended :l -keyword = {bond} or {angle} or {dihedral} :l - {bond} args = atom1 atom2 Kstart Kstop r0 - atom1,atom2 = IDs of 2 atoms in bond - Kstart,Kstop = restraint coefficients at start/end of run (energy units) - r0 = equilibrium bond distance (distance units) - {angle} args = atom1 atom2 atom3 Kstart Kstop theta0 - atom1,atom2,atom3 = IDs of 3 atoms in angle, atom2 = middle atom - Kstart,Kstop = restraint coefficients at start/end of run (energy units) - theta0 = equilibrium angle theta (degrees) - {dihedral} args = atom1 atom2 atom3 atom4 Kstart Kstop phi0 keyword/value - atom1,atom2,atom3,atom4 = IDs of 4 atoms in dihedral in linear order - Kstart,Kstop = restraint coefficients at start/end of run (energy units) - phi0 = equilibrium dihedral angle phi (degrees) - keyword/value = optional keyword value pairs. supported keyword/value pairs: - {mult} n = dihedral multiplicity n (integer >= 0, default = 1) :pre -:ule - -[Examples:] - -fix holdem all restrain bond 45 48 2000.0 2000.0 2.75 -fix holdem all restrain dihedral 1 2 3 4 2000.0 2000.0 120.0 -fix holdem all restrain bond 45 48 2000.0 2000.0 2.75 dihedral 1 2 3 4 2000.0 2000.0 120.0 -fix texas_holdem all restrain dihedral 1 2 3 4 0.0 2000.0 120.0 dihedral 1 2 3 5 0.0 2000.0 -120.0 dihedral 1 2 3 6 0.0 2000.0 0.0 :pre - -[Description:] - -Restrain the motion of the specified sets of atoms by making them part -of a bond or angle or dihedral interaction whose strength can vary -over time during a simulation. This is functionally similar to -creating a bond or angle or dihedral for the same atoms in a data -file, as specified by the "read_data"_read_data.html command, albeit -with a time-varying pre-factor coefficient, and except for exclusion -rules, as explained below. - -For the purpose of force field parameter-fitting or mapping a molecular -potential energy surface, this fix reduces the hassle and risk -associated with modifying data files. In other words, use this fix to -temporarily force a molecule to adopt a particular conformation. To -create a permanent bond or angle or dihedral, you should modify the -data file. - -NOTE: Adding a bond/angle/dihedral with this command does not apply -the exclusion rules and weighting factors specified by the -"special_bonds"_special_bonds.html command to atoms in the restraint -that are now bonded (1-2,1-3,1-4 neighbors) as a result. If they are -close enough to interact in a "pair_style"_pair_style.html sense -(non-bonded interaction), then the bond/angle/dihedral restraint -interaction will simply be superposed on top of that interaction. - -The group-ID specified by this fix is ignored. - -The second example above applies a restraint to hold the dihedral -angle formed by atoms 1, 2, 3, and 4 near 120 degrees using a constant -restraint coefficient. The fourth example applies similar restraints -to multiple dihedral angles using a restraint coefficient that -increases from 0.0 to 2000.0 over the course of the run. - -NOTE: Adding a force to atoms implies a change in their potential -energy as they move due to the applied force field. For dynamics via -the "run"_run.html command, this energy can be added to the system's -potential energy for thermodynamic output (see below). For energy -minimization via the "minimize"_minimize.html command, this energy -must be added to the system's potential energy to formulate a -self-consistent minimization problem (see below). - -In order for a restraint to be effective, the restraint force must -typically be significantly larger than the forces associated with -conventional force field terms. If the restraint is applied during a -dynamics run (as opposed to during an energy minimization), a large -restraint coefficient can significantly reduce the stable timestep -size, especially if the atoms are initially far from the preferred -conformation. You may need to experiment to determine what value of K -works best for a given application. - -For the case of finding a minimum energy structure for a single -molecule with particular restraints (e.g. for fitting force field -parameters or constructing a potential energy surface), commands such -as the following may be useful: - -# minimize molecule energy with restraints -velocity all create 600.0 8675309 mom yes rot yes dist gaussian -fix NVE all nve -fix TFIX all langevin 600.0 0.0 100 24601 -fix REST all restrain dihedral 2 1 3 8 0.0 5000.0 $\{angle1\} dihedral 3 1 2 9 0.0 5000.0 $\{angle2\} -fix_modify REST energy yes -run 10000 -fix TFIX all langevin 0.0 0.0 100 24601 -fix REST all restrain dihedral 2 1 3 8 5000.0 5000.0 $\{angle1\} dihedral 3 1 2 9 5000.0 5000.0 $\{angle2\} -fix_modify REST energy yes -run 10000 -# sanity check for convergence -minimize 1e-6 1e-9 1000 100000 -# report unrestrained energies -unfix REST -run 0 :pre - -:line - -The {bond} keyword applies a bond restraint to the specified atoms -using the same functional form used by the "bond_style -harmonic"_bond_harmonic.html command. The potential associated with -the restraint is - -:c,image(Eqs/bond_harmonic.jpg) - -with the following coefficients: - -K (energy/distance^2) -r0 (distance) :ul - -K and r0 are specified with the fix. Note that the usual 1/2 factor -is included in K. - -:line - -The {angle} keyword applies an angle restraint to the specified atoms -using the same functional form used by the "angle_style -harmonic"_angle_harmonic.html command. The potential associated with -the restraint is - -:c,image(Eqs/angle_harmonic.jpg) - -with the following coefficients: - -K (energy/radian^2) -theta0 (degrees) :ul - -K and theta0 are specified with the fix. Note that the usual 1/2 -factor is included in K. - -:line - -The {dihedral} keyword applies a dihedral restraint to the specified -atoms using a simplified form of the function used by the -"dihedral_style charmm"_dihedral_charmm.html command. The potential -associated with the restraint is - -:c,image(Eqs/dihedral_charmm.jpg) - -with the following coefficients: - -K (energy) -n (multiplicity, >= 0) -d (degrees) = phi0 + 180 :ul - -K and phi0 are specified with the fix. Note that the value of the -dihedral multiplicity {n} is set by default to 1. You can use the -optional {mult} keyword to set it to a different positive integer. -Also note that the energy will be a minimum when the -current dihedral angle phi is equal to phi0. - -:line - -[Restart, fix_modify, output, run start/stop, minimize info:] - -No information about this fix is written to "binary restart -files"_restart.html. - -The "fix_modify"_fix_modify.html {energy} option is supported by this -fix to add the potential energy associated with this fix to the -system's potential energy as part of "thermodynamic -output"_thermo_style.html. - -The "fix_modify"_fix_modify.html {respa} option is supported by this -fix. This allows to set at which level of the "r-RESPA"_run_style.html -integrator the fix is adding its forces. Default is the outermost level. - -NOTE: If you want the fictitious potential energy associated with the -added forces to be included in the total potential energy of the -system (the quantity being minimized), you MUST enable the -"fix_modify"_fix_modify.html {energy} option for this fix. - -This fix computes a global scalar and a global vector of length 3, -which can be accessed by various "output commands"_Howto_output.html. -The scalar is the total potential energy for {all} the restraints as -discussed above. The vector values are the sum of contributions to the -following individual categories: - -1 = bond energy -2 = angle energy -3 = dihedral energy :ul - -The scalar and vector values calculated by this fix are "extensive". - -No parameter of this fix can be used with the {start/stop} keywords of -the "run"_run.html command. - -[Restrictions:] none - -[Related commands:] none - -[Default:] none From 1df3a7173453216bd24ba476fcab3cc45950d1df Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 15:35:19 +0000 Subject: [PATCH 419/557] Updated documentation --- doc/src/bond_oxdna.rst | 75 +- doc/src/pair_oxdna.rst | 45 +- doc/src/pair_oxdna2.rst | 55 +- doc/src/pair_oxrna2.rst | 153 +++ examples/USER/cgdna/README | 44 +- .../cgdna/examples/oxDNA2/duplex3/in.duplex3 | 2 +- .../oxDNA2/duplex3/log.07Aug19.duplex3.g++.1 | 2 +- .../oxDNA2/duplex3/log.07Aug19.duplex3.g++.4 | 2 +- .../examples/oxRNA2/duplex4/data.duplex4 | 96 ++ .../cgdna/examples/oxRNA2/duplex4/in.duplex4 | 80 ++ .../oxRNA2/duplex4/log.30Oct19.duplex4.g++.1 | 1174 +++++++++++++++++ .../oxRNA2/duplex4/log.30Oct19.duplex4.g++.4 | 1174 +++++++++++++++++ 12 files changed, 2809 insertions(+), 93 deletions(-) create mode 100644 doc/src/pair_oxrna2.rst create mode 100644 examples/USER/cgdna/examples/oxRNA2/duplex4/data.duplex4 create mode 100644 examples/USER/cgdna/examples/oxRNA2/duplex4/in.duplex4 create mode 100644 examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.1 create mode 100644 examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.4 diff --git a/doc/src/bond_oxdna.rst b/doc/src/bond_oxdna.rst index 51692f933b..36370ddf30 100644 --- a/doc/src/bond_oxdna.rst +++ b/doc/src/bond_oxdna.rst @@ -6,6 +6,9 @@ bond\_style oxdna/fene command bond\_style oxdna2/fene command =============================== +bond\_style oxrna2/fene command +=============================== + Syntax """""" @@ -16,6 +19,8 @@ Syntax bond_style oxdna2/fene + bond_style oxrna2/fene + Examples """""""" @@ -28,18 +33,21 @@ Examples bond_style oxdna2/fene bond_coeff \* 2.0 0.25 0.7564 + bond_style oxrna2/fene + bond_coeff \* 2.0 0.25 0.76107 + Description """"""""""" -The *oxdna/fene* and *oxdna2/fene* bond styles use the potential +The *oxdna/fene* , *oxdna2/fene* and *oxrna2/fene* bond styles use the potential .. image:: Eqs/bond_oxdna_fene.jpg :align: center to define a modified finite extensible nonlinear elastic (FENE) -potential :ref:`(Ouldridge) ` to model the connectivity of the -phosphate backbone in the oxDNA force field for coarse-grained -modelling of DNA. +potential :ref:`(Ouldridge) ` to model the connectivity of the +phosphate backbone in the oxDNA/oxRNA force field for coarse-grained +modelling of DNA/RNA. The following coefficients must be defined for the bond type via the :doc:`bond\_coeff ` command as given in the above example, or @@ -55,27 +63,36 @@ commands: The oxDNA bond style has to be used together with the corresponding oxDNA pair styles for excluded volume interaction - *oxdna/excv*\ , stacking *oxdna/stk*\ , cross-stacking *oxdna/xstk* and + *oxdna/excv* , stacking *oxdna/stk* , cross-stacking *oxdna/xstk* and coaxial stacking interaction *oxdna/coaxstk* as well as hydrogen-bonding interaction *oxdna/hbond* (see also documentation of :doc:`pair\_style oxdna/excv `). For the oxDNA2 - :ref:`(Snodin) ` bond style the analogous pair styles and an - additional Debye-Hueckel pair style *oxdna2/dh* have to be defined. + :ref:`(Snodin) ` bond style the analogous pair styles + *oxdna2/excv* , *oxdna2/stk* , *oxdna2/xstk* , *oxdna2/coaxstk* , + *oxdna2/hbond* and an additional Debye-Hueckel pair style + *oxdna2/dh* have to be defined. The same applies to the oxRNA2 + :ref:`(Sulc1) ` styles. The coefficients in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. -Example input and data files for DNA duplexes can be found in -examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. A simple python -setup tool which creates single straight or helical DNA strands, DNA -duplexes or arrays of DNA duplexes can be found in +Example input and data files for DNA and RNA duplexes can be found in +examples/USER/cgdna/examples/oxDNA/ , /oxDNA2/ and /oxRNA2/. A simple python +setup tool which creates single straight or helical DNA strands, DNA/RNA +duplexes or arrays of DNA/RNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in -any publication that uses this implementation. The article contains -more information on the model, the structure of the input file, the -setup tool and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found `here `_. +Please cite also the relevant oxDNA/oxRNA publications. These are +:ref:`(Ouldridge) ` and +:ref:`(Ouldridge-DPhil) ` for oxDNA, +:ref:`(Snodin) ` for oxDNA2, +:ref:`(Sulc1) ` for oxRNA2 +and for sequence-specific hydrogen-bonding and stacking interactions +:ref:`(Sulc2) `. ---------- @@ -92,35 +109,37 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`fix nve/dotc/langevin `, -:doc:`bond\_coeff ` +:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`pair\_style oxrna2/excv `, +:doc:`bond\_coeff `, :doc:`fix nve/dotc/langevin ` **Default:** none ---------- +.. _Henrich0: -.. _Henrich2: +**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Ouldridge-DPhil0: +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). -**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, -T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Ouldridge0: -.. _oxdna\_fene: +**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). +.. _Snodin0: +**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). -**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, -J. Chem. Phys. 134, 085101 (2011). +.. _Sulc01: -.. _oxdna2: +**(Sulc1)** P. Sulc, F. Romano, T. E. Ouldridge, et al., J. Chem. Phys. 140, 235102 (2014). +.. _Sulc02: - -**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., -J. Chem. Phys. 142, 234901 (2015). +**(Sulc2)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). .. _lws: http://lammps.sandia.gov diff --git a/doc/src/pair_oxdna.rst b/doc/src/pair_oxdna.rst index b40cf1f6cc..727f19c327 100644 --- a/doc/src/pair_oxdna.rst +++ b/doc/src/pair_oxdna.rst @@ -36,8 +36,8 @@ Syntax *oxdna/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 + xi = 1.3448 (temperature-independent coefficient in stacking strength) + kappa = 2.6568 (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) @@ -94,11 +94,15 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. -The article contains more information on the model, the structure of the input file, the setup tool -and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found `here `_. - +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found +`here `_. +Please cite also the relevant oxDNA publications +:ref:`(Ouldridge) `, +:ref:`(Ouldridge-DPhil) ` +and :ref:`(Sulc) `. ---------- @@ -114,39 +118,32 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv ` - +:doc:`bond\_style oxdna/fene `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv `, +:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, +:doc:`fix nve/dotc/langevin ` + **Default:** none ---------- - .. _Henrich1: - - **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -.. _Sulc1: - - - -**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). - .. _Ouldridge-DPhil1: - - -**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge1: - - **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). +.. _Sulc1: + +**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html diff --git a/doc/src/pair_oxdna2.rst b/doc/src/pair_oxdna2.rst index 4f64197f44..77052da666 100644 --- a/doc/src/pair_oxdna2.rst +++ b/doc/src/pair_oxdna2.rst @@ -39,15 +39,15 @@ Syntax *oxdna2/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 + xi = 1.3523 (temperature-independent coefficient in stacking strength) + kappa = 2.6717 (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 T = temperature (oxDNA units, 0.1 = 300 K) rhos = salt concentration (mole per litre) - qeff = effective charge (elementary charges) + qeff = 0.815 (effective charge in elementary charges) Examples """""""" @@ -63,7 +63,7 @@ Examples 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 0.1 1.0 0.815 + pair_coeff \* \* oxdna2/dh 0.1 0.5 0.815 Description """"""""""" @@ -83,7 +83,7 @@ The exact functional form of the pair styles is rather complex. The individual potentials consist of products of modulation factors, which themselves are constructed from a number of more basic potentials (Morse, Lennard-Jones, harmonic angle and distance) as well as quadratic smoothing and modulation terms. -We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` +We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 force field. .. note:: @@ -94,7 +94,7 @@ and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 fo in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. 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 + after *oxdna2/dh* (T=0.1, rhos=0.5, qeff=0.815 in the above example). When using a Langevin thermostat e.g. through :doc:`fix langevin ` or :doc:`fix nve/dotc/langevin ` the temperature coefficients have to be matched to the one used in the fix. @@ -102,11 +102,13 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. -The article contains more information on the model, the structure of the input file, the setup tool -and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found `here `_. - +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found +`here `_. +Please cite also the relevant oxDNA2 publications +:ref:`(Snodin) ` and :ref:`(Sulc) `. ---------- @@ -122,43 +124,34 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna2/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv ` +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv `, +:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, +:doc:`fix nve/dotc/langevin ` **Default:** none ---------- - -.. _Henrich: - - +.. _Henrich2: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -.. _Sulc2: - - - -**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). - -.. _Snodin: - - +.. _Snodin2: **(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). +.. _Sulc2: + +**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + .. _Ouldridge-DPhil2: - - -**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge2: - - **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). diff --git a/doc/src/pair_oxrna2.rst b/doc/src/pair_oxrna2.rst new file mode 100644 index 0000000000..469851eb5a --- /dev/null +++ b/doc/src/pair_oxrna2.rst @@ -0,0 +1,153 @@ +.. index:: pair\_style oxrna2/excv + +pair\_style oxrna2/excv command +=============================== + +pair\_style oxrna2/stk command +============================== + +pair\_style oxrna2/hbond command +================================ + +pair\_style oxrna2/xstk command +=============================== + +pair\_style oxrna2/coaxstk command +================================== + +pair\_style oxrna2/dh command +============================= + +Syntax +"""""" + + +.. parsed-literal:: + + pair_style style1 + + pair_coeff \* \* style2 args + +* style1 = *hybrid/overlay oxrna2/excv oxrna2/stk oxrna2/hbond oxrna2/xstk oxrna2/coaxstk oxrna2/dh* + +* style2 = *oxrna2/excv* or *oxrna2/stk* or *oxrna2/hbond* or *oxrna2/xstk* or *oxrna2/coaxstk* or *oxrna2/dh* +* args = list of arguments for these particular styles + + +.. parsed-literal:: + + *oxrna2/stk* args = seq T xi kappa 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 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 = 1.40206 (temperature-independent coefficient in stacking strength) + kappa = 2.77 (coefficient of linear temperature dependence in stacking strength) + *oxrna2/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 = 0.870439 (between base pairs A-T, C-G and G-T) or 0 (all other pairs) + *oxrna2/dh* args = T rhos qeff + T = temperature (oxDNA units, 0.1 = 300 K) + rhos = salt concentration (mole per litre) + qeff = 1.02455 (effective charge in elementary charges) + +Examples +"""""""" + + +.. parsed-literal:: + + pair_style hybrid/overlay oxrna2/excv oxrna2/stk oxrna2/hbond oxrna2/xstk oxrna2/coaxstk oxrna2/dh + pair_coeff \* \* oxrna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 + pair_coeff \* \* oxrna2/stk seqdep 0.1 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 + pair_coeff \* \* oxrna2/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 oxrna2/hbond seqdep 0.870439 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 oxrna2/hbond seqdep 0.870439 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 3 4 oxrna2/hbond seqdep 0.870439 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 \* \* oxrna2/xstk 59.9626 0.5 0.6 0.42 0.58 2.25 0.505 0.58 1.7 1.266 0.68 1.7 1.266 0.68 1.7 0.309 0.68 1.7 0.309 0.68 + pair_coeff \* \* oxrna2/coaxstk 80 0.5 0.6 0.42 0.58 2.0 2.592 0.65 1.3 0.151 0.8 0.9 0.685 0.95 0.9 0.685 0.95 2.0 -0.65 2.0 -0.65 + pair_coeff \* \* oxrna2/dh 0.1 0.5 1.02455 + +Description +""""""""""" + +The *oxrna2* pair styles compute the pairwise-additive parts of the oxDNA force field +for coarse-grained modelling of DNA. The effective interaction between the nucleotides consists of potentials for the +excluded volume interaction *oxrna2/excv*\ , the stacking *oxrna2/stk*\ , cross-stacking *oxrna2/xstk* +and coaxial stacking interaction *oxrna2/coaxstk*\ , electrostatic Debye-Hueckel interaction *oxrna2/dh* +as well as the hydrogen-bonding interaction *oxrna2/hbond* between complementary pairs of nucleotides on +opposite strands. Average sequence or sequence-dependent stacking and base-pairing strengths +are supported :ref:`(Sulc) `. Quasi-unique base-pairing between nucleotides can be achieved by using +more complementary pairs of atom types like 5-8 and 6-7, 9-12 and 10-11, 13-16 and 14-15, etc. +This prevents the hybridization of in principle complementary bases within Ntypes/4 bases +up and down along the backbone. + +The exact functional form of the pair styles is rather complex. +The individual potentials consist of products of modulation factors, +which themselves are constructed from a number of more basic potentials +(Morse, Lennard-Jones, harmonic angle and distance) as well as quadratic smoothing and modulation terms. +We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` +and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 force field. + +.. note:: + + These pair styles have to be used together with the related oxDNA2 bond style + *oxrna2/fene* for the connectivity of the phosphate backbone (see also documentation of + :doc:`bond\_style oxrna2/fene `). 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 four coefficients after *oxrna2/stk* (seq=seqdep, T=0.1, xi=1.40206 and kappa=2.77 in the above example), + the first coefficient after *oxrna2/hbond* (seq=seqdep in the above example) and the three coefficients + after *oxrna2/dh* (T=0.1, rhos=0.5, qeff=1.02455 in the above example). When using a Langevin thermostat + e.g. through :doc:`fix langevin ` or :doc:`fix nve/dotc/langevin ` + the temperature coefficients have to be matched to the one used in the fix. + +Example input and data files for DNA duplexes can be found in examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. +A simple python setup tool which creates single straight or helical DNA strands, +DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. + +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found +`here `_. +Please cite also the relevant oxRNA2 publications +:ref:`(Sulc1) ` and :ref:`(Sulc2) `. + +---------- + + +Restrictions +"""""""""""" + + +These pair styles can only be used if LAMMPS was built with the +USER-CGDNA package and the MOLECULE and ASPHERE package. See the +:doc:`Build package ` doc page for more info. + +Related commands +"""""""""""""""" + +:doc:`bond\_style oxrna2/fene `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv `, +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv `, +:doc:`fix nve/dotc/langevin ` + +**Default:** none + + +---------- + +.. _Henrich3: + +**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). + +.. _Sulc31: + +**(Sulc1)** P. Sulc, F. Romano, T. E. Ouldridge, et al., J. Chem. Phys. 140, 235102 (2014). + +.. _Sulc32: + +**(Sulc2)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + + +.. _lws: http://lammps.sandia.gov +.. _ld: Manual.html +.. _lc: Commands_all.html diff --git a/examples/USER/cgdna/README b/examples/USER/cgdna/README index 8a9dc44359..a03490b630 100644 --- a/examples/USER/cgdna/README +++ b/examples/USER/cgdna/README @@ -1,8 +1,12 @@ This directory contains example data and input files -and utility scripts for the oxDNA coarse-grained model -for DNA. +as well as utility scripts for the oxDNA/oxDNA2/oxRNA2 +coarse-grained model for DNA and RNA. + +/******************************************************************************/ + +/examples/oxDNA/duplex1: +/examples/oxDNA2/duplex1: -/examples/duplex1: Input, data and log files for a DNA duplex (double-stranded DNA) consisiting of 5 base pairs. The duplex contains two strands with complementary base pairs. The topology is @@ -11,7 +15,14 @@ A - C - G - T - A | | | | | T - G - C - A - T -/examples/duplex2: +Note that in this example the stacking and hydrogen-bonding interactions +are sequence-averaged (cf. keyword 'seqav' in according pair styles). + +/******************************************************************************/ + +/examples/oxDNA/duplex2: +/examples/oxDNA2/duplex2: + Input, data and log files for a nicked DNA duplex (double-stranded DNA) consisiting of 8 base pairs. The duplex contains strands with complementary base pairs, but the backbone on one side is not continuous: @@ -22,9 +33,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 sequence-dependent stacking -and hydrogen-bonding strengths enabled and both nucleotide mass and +Note that in this example the stacking and hydrogen-bonding interactions +are sequence-averaged (cf. keyword 'seqav' in according pair styles). + +/******************************************************************************/ + +/examples/oxDNA2/duplex3: + +This is 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 @@ -33,6 +50,19 @@ 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. +As mentioned above, the stacking and hydrogen-bonding interactions +are sequence-dependent (cf. keyword 'seqdep' in according pair styles). + +/******************************************************************************/ + +/examples/oxRNA2/duplex4 + +This is the duplex2 run with the oxRNA2 force field instead of the oxDNA or +oxDNA2 force field and sequence-dependent stacking and hydrogen-bonding +strengths enabled. + +/******************************************************************************/ + /util: This directory contains a simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 b/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 index fd75a6fc3f..033783dc15 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/in.duplex3 @@ -1,4 +1,4 @@ -variable number equal 1 +variable number equal 3 variable ofreq equal 1000 variable efreq equal 1000 variable T equal 0.1 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.1 b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.1 index 8f70e9ec96..9172c99492 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.1 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.1 @@ -1,5 +1,5 @@ LAMMPS (7 Aug 2019) -variable number equal 1 +variable number equal 3 variable ofreq equal 1000 variable efreq equal 1000 variable T equal 0.1 diff --git a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.4 b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.4 index f110e20906..491f91e671 100644 --- a/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.4 +++ b/examples/USER/cgdna/examples/oxDNA2/duplex3/log.07Aug19.duplex3.g++.4 @@ -1,5 +1,5 @@ LAMMPS (7 Aug 2019) -variable number equal 1 +variable number equal 3 variable ofreq equal 1000 variable efreq equal 1000 variable T equal 0.1 diff --git a/examples/USER/cgdna/examples/oxRNA2/duplex4/data.duplex4 b/examples/USER/cgdna/examples/oxRNA2/duplex4/data.duplex4 new file mode 100644 index 0000000000..72872d431a --- /dev/null +++ b/examples/USER/cgdna/examples/oxRNA2/duplex4/data.duplex4 @@ -0,0 +1,96 @@ +# LAMMPS data file +16 atoms +16 ellipsoids +13 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 3.1575 +2 3.1575 +3 3.1575 +4 3.1575 + +# 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 2 5.999771538385027e-01 -5.235921299024461e-03 1.948814275651561e+00 1 1 1 +7 3 4.890766774371325e-01 3.475687034056071e-01 2.338577130781873e+00 1 1 1 +8 4 1.923677943514057e-01 5.683261666476170e-01 2.728339985912185e+00 1 1 1 +9 1 -1.923677943514057e-01 -5.683261666476170e-01 2.728339985912185e+00 2 1 1 +10 2 -4.890766774371324e-01 -3.475687034056071e-01 2.338577130781873e+00 2 1 1 +11 3 -5.999771538385025e-01 5.235921299024461e-03 1.948814275651561e+00 2 1 1 +12 4 -4.829362784135481e-01 3.560513319622207e-01 1.559051420521249e+00 2 1 1 +13 1 -1.824198365552940e-01 5.715968887521514e-01 1.169288565390936e+00 2 1 1 +14 2 1.874009511073395e-01 5.699832309147912e-01 7.795257102606241e-01 2 1 1 +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 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 +11 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +12 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +13 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +14 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +15 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +16 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 + +# Atom-ID, shape, quaternion +Ellipsoids + +1 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 1.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +2 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.513258223252946e-01 0.000000000000000e+00 0.000000000000000e+00 3.081869234362515e-01 +3 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 8.100416404457962e-01 0.000000000000000e+00 0.000000000000000e+00 5.863723567357894e-01 +4 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 5.899012371043606e-01 0.000000000000000e+00 0.000000000000000e+00 8.074754054847398e-01 +5 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 3.123349185122326e-01 0.000000000000000e+00 0.000000000000000e+00 9.499720515246527e-01 +6 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 4.363309284746654e-03 0.000000000000000e+00 0.000000000000000e+00 9.999904807207346e-01 +7 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -3.040330609254902e-01 0.000000000000000e+00 0.000000000000000e+00 9.526614812535865e-01 +8 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 5.828323126827837e-01 0.000000000000000e+00 0.000000000000000e+00 -8.125924533816677e-01 +9 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 8.125924533816681e-01 5.828323126827832e-01 -0.000000000000000e+00 +10 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.526614812535864e-01 3.040330609254902e-01 0.000000000000000e+00 +11 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.999904807207346e-01 -4.363309284746654e-03 0.000000000000000e+00 +12 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.499720515246526e-01 -3.123349185122325e-01 0.000000000000000e+00 +13 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 8.074754054847402e-01 -5.899012371043603e-01 0.000000000000000e+00 +14 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 5.863723567357898e-01 -8.100416404457959e-01 0.000000000000000e+00 +15 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 -3.081869234362514e-01 9.513258223252948e-01 0.000000000000000e+00 +16 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 2.775557561562893e-17 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 5 6 +6 1 6 7 +7 1 7 8 +8 1 9 10 +9 1 10 11 +10 1 11 12 +11 1 13 14 +12 1 14 15 +13 1 15 16 diff --git a/examples/USER/cgdna/examples/oxRNA2/duplex4/in.duplex4 b/examples/USER/cgdna/examples/oxRNA2/duplex4/in.duplex4 new file mode 100644 index 0000000000..ed2fafbe8b --- /dev/null +++ b/examples/USER/cgdna/examples/oxRNA2/duplex4/in.duplex4 @@ -0,0 +1,80 @@ +variable number equal 4 +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.duplex4 + +set atom * mass 3.1575 + +group all type 1 4 + +# oxRNA2 bond interactions - FENE backbone +bond_style oxrna2/fene +bond_coeff * 2.0 0.25 0.761070781051 + +# oxRNA2 pair interactions +pair_style hybrid/overlay oxrna2/excv oxrna2/stk oxrna2/hbond oxrna2/xstk oxrna2/coaxstk oxrna2/dh + +pair_coeff * * oxrna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxrna2/stk seqdep ${T} 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 +pair_coeff * * oxrna2/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 oxrna2/hbond seqdep 0.870439 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 oxrna2/hbond seqdep 0.870439 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 3 4 oxrna2/hbond seqdep 0.870439 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 * * oxrna2/xstk 59.9626 0.5 0.6 0.42 0.58 2.25 0.505 0.58 1.7 1.266 0.68 1.7 1.266 0.68 1.7 0.309 0.68 1.7 0.309 0.68 +pair_coeff * * oxrna2/coaxstk 80 0.5 0.6 0.42 0.58 2.0 2.592 0.65 1.3 0.151 0.8 0.9 0.685 0.95 0.9 0.685 0.95 2.0 -0.65 2.0 -0.65 +pair_coeff * * oxrna2/dh ${T} 0.5 1.02455 + +# NVE ensemble +#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/dot +fix 1 all nve/asphere + +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.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f" + +run 1000000 + +#write_restart config.${number}.* diff --git a/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.1 b/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.1 new file mode 100644 index 0000000000..d4c9fa3fcc --- /dev/null +++ b/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.1 @@ -0,0 +1,1174 @@ +LAMMPS (30 Oct 2019) +variable number equal 4 +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.duplex4 + 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 = 5.9e-05 secs + read_data CPU = 0.038375 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxRNA2 bond interactions - FENE backbone +bond_style oxrna2/fene +bond_coeff * 2.0 0.25 0.761070781051 + +# oxRNA2 pair interactions +pair_style hybrid/overlay oxrna2/excv oxrna2/stk oxrna2/hbond oxrna2/xstk oxrna2/coaxstk oxrna2/dh + +pair_coeff * * oxrna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxrna2/stk seqdep ${T} 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 +pair_coeff * * oxrna2/stk seqdep 0.1 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 +pair_coeff * * oxrna2/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 oxrna2/hbond seqdep 0.870439 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 oxrna2/hbond seqdep 0.870439 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 3 4 oxrna2/hbond seqdep 0.870439 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 * * oxrna2/xstk 59.9626 0.5 0.6 0.42 0.58 2.25 0.505 0.58 1.7 1.266 0.68 1.7 1.266 0.68 1.7 0.309 0.68 1.7 0.309 0.68 +pair_coeff * * oxrna2/coaxstk 80 0.5 0.6 0.42 0.58 2.0 2.592 0.65 1.3 0.151 0.8 0.9 0.685 0.95 0.9 0.685 0.95 2.0 -0.65 2.0 -0.65 +pair_coeff * * oxrna2/dh ${T} 0.5 1.02455 +pair_coeff * * oxrna2/dh 0.1 0.5 1.02455 + +# NVE ensemble +#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/dot +fix 1 all nve/asphere + +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.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f" + +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 = 3.3015 + ghost atom cutoff = 3.3015 + binsize = 1.65075, bins = 25 25 25 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxrna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxrna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxrna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxrna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxrna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxrna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +0 ekin = 0 | erot = 0 | epot = -13.282537590974 | etot = -13.282537590974 +Per MPI rank memory allocation (min/avg/max) = 2.951 | 2.951 | 2.951 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -0.84341458 0.013255977 -0.8301586 -2.0169485e-05 +1000 ekin = 0.00448503054656468 | erot = 0.00825381229611384 | epot = -13.2952764343122 | etot = -13.2825375914695 +2000 ekin = 0.0179027901180511 | erot = 0.0327684151335467 | epot = -13.3332087967732 | etot = -13.2825375915216 +3000 ekin = 0.0401478317723584 | erot = 0.0728240143066062 | epot = -13.3955094376815 | etot = -13.2825375916026 +4000 ekin = 0.0710654348932282 | erot = 0.127292706283096 | epot = -13.4808957328808 | etot = -13.2825375917044 +5000 ekin = 0.110480309743662 | erot = 0.194739074279834 | epot = -13.5877569758405 | etot = -13.282537591817 +6000 ekin = 0.158231230694432 | erot = 0.273546913858903 | epot = -13.7143157364827 | etot = -13.2825375919294 +7000 ekin = 0.214206450831754 | erot = 0.362058396901232 | epot = -13.8588024397642 | etot = -13.2825375920312 +8000 ekin = 0.278374111850069 | erot = 0.458709556672181 | epot = -14.0196212606361 | etot = -13.2825375921138 +9000 ekin = 0.35080209403022 | erot = 0.562145629088178 | epot = -14.1954853152903 | etot = -13.2825375921719 +10000 ekin = 0.431663021447766 | erot = 0.671302139462136 | epot = -14.385502753114 | etot = -13.2825375922041 +11000 ekin = 0.521222365620265 | erot = 0.78544264622411 | epot = -14.5892026040572 | etot = -13.2825375922128 +12000 ekin = 0.61981039873542 | erot = 0.904150888366026 | epot = -14.8064988793055 | etot = -13.2825375922041 +13000 ekin = 0.72778153179885 | erot = 1.02728222251243 | epot = -15.0376013464974 | etot = -13.2825375921861 +14000 ekin = 0.845466747659446 | erot = 1.154885201864 | epot = -15.2828895416915 | etot = -13.2825375921681 +15000 ekin = 0.973515286429446 | erot = 1.28640002432487 | epot = -15.5424529041413 | etot = -13.2825375933869 +16000 ekin = 1.12323013751098 | erot = 1.40387495398598 | epot = -15.8096426839256 | etot = -13.2825375924286 +17000 ekin = 1.2976927283263 | erot = 1.51347784068661 | epot = -16.0937081607397 | etot = -13.2825375917268 +18000 ekin = 1.48565191084531 | erot = 1.63592970999661 | epot = -16.4041192134347 | etot = -13.2825375925928 +19000 ekin = 1.66750911163348 | erot = 1.77940241938721 | epot = -16.7294491246368 | etot = -13.2825375936161 +20000 ekin = 1.84148924290423 | erot = 1.93695511183687 | epot = -17.0609819484057 | etot = -13.2825375936646 +21000 ekin = 2.02307741366163 | erot = 2.09844265792961 | epot = -17.4040576653939 | etot = -13.2825375938027 +22000 ekin = 2.21183606977224 | erot = 2.26260708947302 | epot = -17.7569807531587 | etot = -13.2825375939134 +23000 ekin = 2.40735468792977 | erot = 2.42817202047308 | epot = -18.1180643024997 | etot = -13.2825375940968 +24000 ekin = 2.60896890448861 | erot = 2.59357882573853 | epot = -18.485085324508 | etot = -13.2825375942809 +25000 ekin = 2.81580135477345 | erot = 2.75706655667055 | epot = -18.855405505957 | etot = -13.282537594513 +26000 ekin = 3.02680083558485 | erot = 2.91667946897257 | epot = -19.2260178993271 | etot = -13.2825375947697 +27000 ekin = 3.24067707260308 | erot = 3.07027299756498 | epot = -19.5934876652175 | etot = -13.2825375950495 +28000 ekin = 3.45601412953572 | erot = 3.21560615188039 | epot = -19.9541578767293 | etot = -13.2825375953132 +29000 ekin = 3.6713683081319 | erot = 3.35037905822946 | epot = -20.304284961999 | etot = -13.2825375956376 +30000 ekin = 3.88476027224393 | erot = 3.47208481891837 | epot = -20.639382687185 | etot = -13.2825375960227 +31000 ekin = 4.09387957878895 | erot = 3.57821385032035 | epot = -20.9546310254509 | etot = -13.2825375963416 +32000 ekin = 4.29662185345806 | erot = 3.66648606531138 | epot = -21.2456455154186 | etot = -13.2825375966492 +33000 ekin = 4.49089153394062 | erot = 3.73482555362569 | epot = -21.5082546845018 | etot = -13.2825375969355 +34000 ekin = 4.67464118182276 | erot = 3.78142516888995 | epot = -21.738603947901 | etot = -13.2825375971883 +35000 ekin = 4.84586411782047 | erot = 3.80480460777895 | epot = -21.9332063229962 | etot = -13.2825375973967 +36000 ekin = 5.00270940487365 | erot = 3.8039453503275 | epot = -22.0891923527593 | etot = -13.2825375975582 +37000 ekin = 5.14355281474259 | erot = 3.7783370953036 | epot = -22.204427507712 | etot = -13.2825375976658 +38000 ekin = 5.26699752588855 | erot = 3.72801268545693 | epot = -22.2775478090594 | etot = -13.2825375977139 +39000 ekin = 5.37191151713863 | erot = 3.65359747923659 | epot = -22.3080465940736 | etot = -13.2825375976984 +40000 ekin = 5.45746010972423 | erot = 3.55633701588595 | epot = -22.2963347232305 | etot = -13.2825375976203 +41000 ekin = 5.52312188621308 | erot = 3.43809872369854 | epot = -22.2437582073842 | etot = -13.2825375974726 +42000 ekin = 5.56872044211992 | erot = 3.30135279333163 | epot = -22.1526108327155 | etot = -13.2825375972639 +43000 ekin = 5.59443660082917 | erot = 3.14910305123731 | epot = -22.0260772490691 | etot = -13.2825375970026 +44000 ekin = 5.60078634437692 | erot = 2.98477133565124 | epot = -21.8680952767294 | etot = -13.2825375967012 +45000 ekin = 5.58859564323333 | erot = 2.81204277265316 | epot = -21.6831760122617 | etot = -13.2825375963752 +46000 ekin = 5.55896198288794 | erot = 2.63469562167501 | epot = -21.4761952006007 | etot = -13.2825375960378 +47000 ekin = 5.51320424221946 | erot = 2.45646420183046 | epot = -21.2522060397483 | etot = -13.2825375956984 +48000 ekin = 5.45280176988517 | erot = 2.28095947573118 | epot = -21.0162988409769 | etot = -13.2825375953605 +49000 ekin = 5.37933239946638 | erot = 2.11161440403257 | epot = -20.7734843985446 | etot = -13.2825375950457 +50000 ekin = 5.29440598595185 | erot = 1.95156309993188 | epot = -20.5285066806346 | etot = -13.2825375947508 +51000 ekin = 5.19960275040233 | erot = 1.8036634398305 | epot = -20.2858037847152 | etot = -13.2825375944824 +52000 ekin = 5.09244091535756 | erot = 1.66034071449473 | epot = -20.0353192196127 | etot = -13.2825375897604 +53000 ekin = 5.00219098599272 | erot = 1.54003539006211 | epot = -19.8247639698981 | etot = -13.2825375938433 +54000 ekin = 4.90058329526777 | erot = 1.45132465506075 | epot = -19.6344455614683 | etot = -13.2825376111398 +55000 ekin = 4.70838087935139 | erot = 1.38368494594893 | epot = -19.3746034336678 | etot = -13.2825376083675 +56000 ekin = 4.44064498303545 | erot = 1.42525549496303 | epot = -19.1484380668508 | etot = -13.2825375888523 +57000 ekin = 4.28012764787285 | erot = 1.59067222265512 | epot = -19.1533374833604 | etot = -13.2825376128325 +58000 ekin = 4.17606446205098 | erot = 1.6926959141941 | epot = -19.1512979674148 | etot = -13.2825375911697 +59000 ekin = 4.0674801293444 | erot = 1.75788112721294 | epot = -19.1078988477137 | etot = -13.2825375911564 +60000 ekin = 3.9544882347638 | erot = 1.84391663061768 | epot = -19.0809424565336 | etot = -13.2825375911521 +61000 ekin = 3.83840387031284 | erot = 1.95003019237208 | epot = -19.0709716537088 | etot = -13.2825375910239 +62000 ekin = 3.72130809963045 | erot = 2.07501703895377 | epot = -19.0788627296237 | etot = -13.2825375910394 +63000 ekin = 3.60440089032981 | erot = 2.21773397929798 | epot = -19.1046724606768 | etot = -13.282537591049 +64000 ekin = 3.48898621429844 | erot = 2.37695650761985 | epot = -19.1484803129713 | etot = -13.282537591053 +65000 ekin = 3.37647880025293 | erot = 2.55140907448467 | epot = -19.2104254657961 | etot = -13.2825375910585 +66000 ekin = 3.26833067403372 | erot = 2.73974236805088 | epot = -19.2906106331593 | etot = -13.2825375910747 +67000 ekin = 3.16594788215578 | erot = 2.94047174698236 | epot = -19.3889572202528 | etot = -13.2825375911146 +68000 ekin = 3.07060531612276 | erot = 3.15188029478627 | epot = -19.5050232021015 | etot = -13.2825375911924 +69000 ekin = 2.98334905059819 | erot = 3.37190853325577 | epot = -19.6377951751758 | etot = -13.2825375913219 +70000 ekin = 2.90492955397884 | erot = 3.59802295152975 | epot = -19.7854900970223 | etot = -13.2825375915137 +71000 ekin = 2.83572376329218 | erot = 3.8271560839742 | epot = -19.9454174390314 | etot = -13.282537591765 +72000 ekin = 2.77568510798997 | erot = 4.05569348668259 | epot = -20.1139161867768 | etot = -13.2825375921043 +73000 ekin = 2.72437405649527 | erot = 4.27929863267978 | epot = -20.2862102816556 | etot = -13.2825375924805 +74000 ekin = 2.6809894320095 | erot = 4.4934031024691 | epot = -20.4569301273605 | etot = -13.2825375928819 +75000 ekin = 2.6444530940616 | erot = 4.69339307186043 | epot = -20.6203837591939 | etot = -13.2825375932719 +76000 ekin = 2.61355415206022 | erot = 4.87501053156087 | epot = -20.7711022772329 | etot = -13.2825375936118 +77000 ekin = 2.58710084062323 | erot = 5.03478939172066 | epot = -20.9044278262183 | etot = -13.2825375938744 +78000 ekin = 2.56403853914049 | erot = 5.17029283961051 | epot = -21.0168689727798 | etot = -13.2825375940288 +79000 ekin = 2.54361120788211 | erot = 5.28037161018751 | epot = -21.1065204121487 | etot = -13.2825375940791 +80000 ekin = 2.52540527324247 | erot = 5.36512720853065 | epot = -21.173070075803 | etot = -13.2825375940298 +81000 ekin = 2.50929384303298 | erot = 5.42576598242971 | epot = -21.2175974194025 | etot = -13.2825375939398 +82000 ekin = 2.49524917644589 | erot = 5.46414530531067 | epot = -21.2419320755728 | etot = -13.2825375938163 +83000 ekin = 2.4833426959312 | erot = 5.48242032921998 | epot = -21.248300618845 | etot = -13.2825375936939 +84000 ekin = 2.47365997802594 | erot = 5.48271691205541 | epot = -21.2389144836696 | etot = -13.2825375935882 +85000 ekin = 2.46626808184772 | erot = 5.46691083838924 | epot = -21.2157165137399 | etot = -13.2825375935029 +86000 ekin = 2.46123154184243 | erot = 5.43653398177485 | epot = -21.1803031170841 | etot = -13.2825375934668 +87000 ekin = 2.45852093879055 | erot = 5.39265692383446 | epot = -21.1337154560121 | etot = -13.2825375933871 +88000 ekin = 2.45840646060175 | erot = 5.33627030736198 | epot = -21.0772143612561 | etot = -13.2825375932924 +89000 ekin = 2.46146480126887 | erot = 5.26838646846783 | epot = -21.0123888631742 | etot = -13.2825375934375 +90000 ekin = 2.4677317783594 | erot = 5.18930366181446 | epot = -20.9395730335193 | etot = -13.2825375933455 +91000 ekin = 2.47726011905719 | erot = 5.09951749277777 | epot = -20.8593152050595 | etot = -13.2825375932246 +92000 ekin = 2.49074261962909 | erot = 5.00022791911595 | epot = -20.7735081318254 | etot = -13.2825375930803 +93000 ekin = 2.50902833057362 | erot = 4.89281259013106 | epot = -20.6843785136292 | etot = -13.2825375929245 +94000 ekin = 2.53301288183075 | erot = 4.77876912035546 | epot = -20.5943195949544 | etot = -13.2825375927682 +95000 ekin = 2.56354598704907 | erot = 4.6596420581626 | epot = -20.5057256378352 | etot = -13.2825375926235 +96000 ekin = 2.60133194738611 | erot = 4.53693642149354 | epot = -20.4208059613806 | etot = -13.2825375925009 +97000 ekin = 2.64684712537105 | erot = 4.41204173729005 | epot = -20.3414264550665 | etot = -13.2825375924053 +98000 ekin = 2.70029551800324 | erot = 4.28619503995162 | epot = -20.2690281502928 | etot = -13.2825375923379 +99000 ekin = 2.76159183076381 | erot = 4.16048163754163 | epot = -20.2046110606006 | etot = -13.2825375922951 +100000 ekin = 2.83036874776579 | erot = 4.03587523010376 | epot = -20.1487815701408 | etot = -13.2825375922712 +101000 ekin = 2.90599845693996 | erot = 3.91330077540588 | epot = -20.1018368246064 | etot = -13.2825375922606 +102000 ekin = 2.98761606367604 | erot = 3.79369343963812 | epot = -20.0638470955752 | etot = -13.2825375922611 +103000 ekin = 3.07413620026802 | erot = 3.67802597580043 | epot = -20.0346997683418 | etot = -13.2825375922734 +104000 ekin = 3.16426099663645 | erot = 3.56728973636564 | epot = -20.0140883253047 | etot = -13.2825375923026 +105000 ekin = 3.25648344622793 | erot = 3.46242766269272 | epot = -20.0014487012763 | etot = -13.2825375923557 +106000 ekin = 3.34909407537355 | erot = 3.36423261094161 | epot = -19.9958642787542 | etot = -13.282537592439 +107000 ekin = 3.4401993069765 | erot = 3.27323316283015 | epot = -19.9959700623645 | etot = -13.2825375925578 +108000 ekin = 3.52775814523602 | erot = 3.18959025645786 | epot = -19.999885994407 | etot = -13.2825375927131 +109000 ekin = 3.60964009104214 | erot = 3.11302339299888 | epot = -20.0052010769433 | etot = -13.2825375929023 +110000 ekin = 3.68370388524509 | erot = 3.04277828887564 | epot = -20.0090197672386 | etot = -13.2825375931179 +111000 ekin = 3.74789440567183 | erot = 2.97764201100029 | epot = -20.0080740100205 | etot = -13.2825375933484 +112000 ekin = 3.80035415830428 | erot = 2.91600823448521 | epot = -19.9988999863676 | etot = -13.2825375935781 +113000 ekin = 3.839544891464 | erot = 2.8559933088984 | epot = -19.9780757941506 | etot = -13.2825375937882 +114000 ekin = 3.86437452036816 | erot = 2.79560177874327 | epot = -19.9425138930678 | etot = -13.2825375939563 +115000 ekin = 3.87432139555448 | erot = 2.7329343736024 | epot = -19.8897933632161 | etot = -13.2825375940592 +116000 ekin = 3.86954570193439 | erot = 2.66642221950682 | epot = -19.8185055155168 | etot = -13.2825375940755 +117000 ekin = 3.85097050791378 | erot = 2.59505981730843 | epot = -19.7285679191997 | etot = -13.2825375939775 +118000 ekin = 3.82031843896371 | erot = 2.51866416069826 | epot = -19.6215201934448 | etot = -13.2825375937828 +119000 ekin = 3.78008379969918 | erot = 2.43788144963878 | epot = -19.5005028428254 | etot = -13.2825375934874 +120000 ekin = 3.73339325084433 | erot = 2.35417060362233 | epot = -19.3701014475786 | etot = -13.282537593112 +121000 ekin = 3.68379362023519 | erot = 2.26974086129527 | epot = -19.23607207422 | etot = -13.2825375926895 +122000 ekin = 3.63497633455468 | erot = 2.18733107351197 | epot = -19.1048450003258 | etot = -13.2825375922591 +123000 ekin = 3.59047168903067 | erot = 2.10992442969337 | epot = -18.9829337105841 | etot = -13.2825375918601 +124000 ekin = 3.55336069064742 | erot = 2.040449477976 | epot = -18.8763477601487 | etot = -13.2825375915253 +125000 ekin = 3.526052756485 | erot = 1.98151529341996 | epot = -18.7901056411805 | etot = -13.2825375912756 +126000 ekin = 3.51088386083626 | erot = 1.93492307727824 | epot = -18.728344529054 | etot = -13.2825375909395 +127000 ekin = 3.51016542665131 | erot = 1.90135594382336 | epot = -18.6940589614221 | etot = -13.2825375909474 +128000 ekin = 3.52366007691459 | erot = 1.88146923500262 | epot = -18.6876669021183 | etot = -13.2825375902011 +129000 ekin = 3.52804447871109 | erot = 1.87939379818812 | epot = -18.6899759099344 | etot = -13.2825376330352 +130000 ekin = 3.39121727536937 | erot = 1.95375354402963 | epot = -18.6275084102343 | etot = -13.2825375908353 +131000 ekin = 3.51597185423296 | erot = 2.06600773707502 | epot = -18.8645172230933 | etot = -13.2825376317853 +132000 ekin = 3.65680948155273 | erot = 2.09675964820427 | epot = -19.0361067214651 | etot = -13.2825375917081 +133000 ekin = 3.78260898444153 | erot = 2.11778864665409 | epot = -19.1829352240667 | etot = -13.2825375929711 +134000 ekin = 3.90291219401782 | erot = 2.13993246768634 | epot = -19.3253822549312 | etot = -13.282537593227 +135000 ekin = 4.0130725329214 | erot = 2.16317596346888 | epot = -19.4587860898102 | etot = -13.2825375934199 +136000 ekin = 4.10942813981085 | erot = 2.18779054238602 | epot = -19.579756275755 | etot = -13.2825375935581 +137000 ekin = 4.18918244084739 | erot = 2.21413018926373 | epot = -19.6858502237401 | etot = -13.282537593629 +138000 ekin = 4.25055180725538 | erot = 2.24252417705096 | epot = -19.7756135779486 | etot = -13.2825375936422 +139000 ekin = 4.29264193993076 | erot = 2.27334414892611 | epot = -19.8485236824514 | etot = -13.2825375935945 +140000 ekin = 4.31542981069473 | erot = 2.30704736065647 | epot = -19.9050147648392 | etot = -13.282537593488 +141000 ekin = 4.31969657449582 | erot = 2.34420108979785 | epot = -19.9464352576258 | etot = -13.2825375933322 +142000 ekin = 4.30689625825181 | erot = 2.38546661972145 | epot = -19.9749004711164 | etot = -13.2825375931432 +143000 ekin = 4.27897643633865 | erot = 2.43154322469962 | epot = -19.9930572539778 | etot = -13.2825375929395 +144000 ekin = 4.23817759048809 | erot = 2.4830525431645 | epot = -20.0037677263996 | etot = -13.282537592747 +145000 ekin = 4.18683687366757 | erot = 2.54040585524226 | epot = -20.0097803214924 | etot = -13.2825375925826 +146000 ekin = 4.1272243777605 | erot = 2.60369949546902 | epot = -20.0134614656897 | etot = -13.2825375924601 +147000 ekin = 4.06142641942193 | erot = 2.67262771534946 | epot = -20.0165917271588 | etot = -13.2825375923874 +148000 ekin = 3.9912803569092 | erot = 2.74643868481959 | epot = -20.0202566340943 | etot = -13.2825375923655 +149000 ekin = 3.91835859675027 | erot = 2.82393987441759 | epot = -20.0248360635575 | etot = -13.2825375923896 +150000 ekin = 3.84399502540854 | erot = 2.90355368904202 | epot = -20.0300863068999 | etot = -13.2825375924493 +151000 ekin = 3.76934462696646 | erot = 2.98342057410476 | epot = -20.0353027936018 | etot = -13.2825375925305 +152000 ekin = 3.69546503896298 | erot = 3.06154297168136 | epot = -20.0395456032602 | etot = -13.2825375926159 +153000 ekin = 3.62340677772839 | erot = 3.13595781467703 | epot = -20.0419021850935 | etot = -13.2825375926881 +154000 ekin = 3.55429442921676 | erot = 3.20491770297265 | epot = -20.0417497249216 | etot = -13.2825375927321 +155000 ekin = 3.48935808553585 | erot = 3.26703376494699 | epot = -20.0389294432276 | etot = -13.2825375927448 +156000 ekin = 3.42995719397496 | erot = 3.32146386703849 | epot = -20.0339586537003 | etot = -13.2825375926868 +157000 ekin = 3.37758377439356 | erot = 3.36807693572793 | epot = -20.0281983027502 | etot = -13.2825375926288 +158000 ekin = 3.32977839475207 | erot = 3.40502394976504 | epot = -20.0173399361875 | etot = -13.2825375916704 +159000 ekin = 3.28790229188226 | erot = 3.43232801110884 | epot = -20.0027678906268 | etot = -13.2825375876357 +160000 ekin = 3.2827995172835 | erot = 3.46457454882488 | epot = -20.0299116571487 | etot = -13.2825375910404 +161000 ekin = 3.29006841785848 | erot = 3.48756894666501 | epot = -20.0601749524886 | etot = -13.2825375879651 +162000 ekin = 3.30320279765029 | erot = 3.50064541816097 | epot = -20.0863858038423 | etot = -13.282537588031 +163000 ekin = 3.32680445360257 | erot = 3.50703979240478 | epot = -20.1163818341648 | etot = -13.2825375881575 +164000 ekin = 3.35978204864574 | erot = 3.50639799900046 | epot = -20.1487176359768 | etot = -13.2825375883306 +165000 ekin = 3.40052448161995 | erot = 3.49807859199014 | epot = -20.1811406621343 | etot = -13.2825375885243 +166000 ekin = 3.44710440323596 | erot = 3.48135096319306 | epot = -20.2109929551315 | etot = -13.2825375887025 +167000 ekin = 3.4975648313672 | erot = 3.45565303648312 | epot = -20.2357554566791 | etot = -13.2825375888288 +168000 ekin = 3.55023572858497 | erot = 3.42084325030349 | epot = -20.2536165677605 | etot = -13.282537588872 +169000 ekin = 3.60406985696843 | erot = 3.37750569995077 | epot = -20.2641131456975 | etot = -13.2825375887783 +170000 ekin = 3.41798406778448 | erot = 3.07782048145476 | epot = -19.7783420668553 | etot = -13.282537517616 +171000 ekin = 3.24552871157827 | erot = 2.73637390316214 | epot = -19.2644400103087 | etot = -13.2825373955683 +172000 ekin = 3.78367855051371 | erot = 3.0727453748938 | epot = -20.1389614956922 | etot = -13.2825375702847 +173000 ekin = 4.03457273059443 | erot = 3.1833646910841 | epot = -20.5004749222031 | etot = -13.2825375005245 +174000 ekin = 4.14002439986023 | erot = 3.16763893899922 | epot = -20.5902008391762 | etot = -13.2825375003167 +175000 ekin = 4.24061478727573 | erot = 3.15086312051219 | epot = -20.6740154078953 | etot = -13.2825375001074 +176000 ekin = 4.33750550891641 | erot = 3.1355261006119 | epot = -20.7555691095056 | etot = -13.2825374999773 +177000 ekin = 4.43118634626255 | erot = 3.12342668205083 | epot = -20.8371505282964 | etot = -13.282537499983 +178000 ekin = 4.52112038535911 | erot = 3.11516996838714 | epot = -20.9188278538863 | etot = -13.28253750014 +179000 ekin = 4.60569122910559 | erot = 3.10997891303161 | epot = -20.9982076425525 | etot = -13.2825375004153 +180000 ekin = 4.68248742105205 | erot = 3.10587534040976 | epot = -21.0709002621995 | etot = -13.2825375007377 +181000 ekin = 4.74885008880769 | erot = 3.10016969122633 | epot = -21.1315572810546 | etot = -13.2825375010206 +182000 ekin = 4.80252004240904 | erot = 3.09010778323153 | epot = -21.1751653268271 | etot = -13.2825375011865 +183000 ekin = 4.84185836209392 | erot = 3.07355401450656 | epot = -21.1979498780501 | etot = -13.2825375014496 +184000 ekin = 4.86305938218274 | erot = 3.04972947015758 | epot = -21.1953263537857 | etot = -13.2825375014454 +185000 ekin = 4.86484048379853 | erot = 3.01830532387125 | epot = -21.165683308955 | etot = -13.2825375012852 +186000 ekin = 4.84781115921877 | erot = 2.97987576045986 | epot = -21.1102244206817 | etot = -13.2825375010031 +187000 ekin = 4.8135776433552 | erot = 2.93597501879465 | epot = -21.032090162799 | etot = -13.2825375006491 +188000 ekin = 4.76439584097176 | erot = 2.8887503176203 | epot = -20.9356836588659 | etot = -13.2825375002739 +189000 ekin = 4.7028202134345 | erot = 2.84056846871295 | epot = -20.8259261820664 | etot = -13.282537499919 +190000 ekin = 4.63141632940872 | erot = 2.79367442377689 | epot = -20.7076282527969 | etot = -13.2825374996113 +191000 ekin = 4.55257205219687 | erot = 2.74995133907398 | epot = -20.5850608906317 | etot = -13.2825374993609 +192000 ekin = 4.46841445137449 | erot = 2.7108083514329 | epot = -20.4617603019722 | etot = -13.2825374991648 +193000 ekin = 4.38080987485702 | erot = 2.67717312167301 | epot = -20.3405204955445 | etot = -13.2825374990145 +194000 ekin = 4.29140314493158 | erot = 2.64952891334607 | epot = -20.2234695571822 | etot = -13.2825374989045 +195000 ekin = 4.20164846020147 | erot = 2.62793199519283 | epot = -20.1121179542319 | etot = -13.2825374988376 +196000 ekin = 4.112799736886 | erot = 2.6119729730638 | epot = -20.0073102087726 | etot = -13.2825374988228 +197000 ekin = 4.0258589719236 | erot = 2.60069607327732 | epot = -19.9090925440707 | etot = -13.2825374988698 +198000 ekin = 3.94151021740635 | erot = 2.59254113732139 | epot = -19.8165888537063 | etot = -13.2825374989786 +199000 ekin = 3.86008920571504 | erot = 2.58539978552083 | epot = -19.728026490366 | etot = -13.2825374991301 +200000 ekin = 3.78163650515412 | erot = 2.57685633277384 | epot = -19.6410303372136 | etot = -13.2825374992857 +201000 ekin = 3.70604145366868 | erot = 2.56461316993842 | epot = -19.5531921230031 | etot = -13.282537499396 +202000 ekin = 3.63323784111708 | erot = 2.54700321074533 | epot = -19.4627785512819 | etot = -13.2825374994195 +203000 ekin = 3.56337600429933 | erot = 2.52342549129417 | epot = -19.3693389949301 | etot = -13.2825374993366 +204000 ekin = 3.49690618989364 | erot = 2.49455276327499 | epot = -19.2739964523245 | etot = -13.2825374991559 +205000 ekin = 3.43455338767261 | erot = 2.46224574346265 | epot = -19.1793366300441 | etot = -13.2825374989088 +206000 ekin = 3.37721205721374 | erot = 2.42921548153353 | epot = -19.0889650373857 | etot = -13.2825374986384 +207000 ekin = 3.32580575275754 | erot = 2.39854397251178 | epot = -19.0068872236571 | etot = -13.2825374983878 +208000 ekin = 3.28114891016496 | erot = 2.37318814654829 | epot = -18.9368745549054 | etot = -13.2825374981921 +209000 ekin = 3.24383236356932 | erot = 2.35556506548921 | epot = -18.8819349271337 | etot = -13.2825374980752 +210000 ekin = 3.21413821976281 | erot = 2.34727297364745 | epot = -18.8439486914582 | etot = -13.282537498048 +211000 ekin = 3.19199204395966 | erot = 2.34895966766644 | epot = -18.823489209736 | etot = -13.2825374981099 +212000 ekin = 3.17695628121177 | erot = 2.360321472034 | epot = -18.819815251497 | etot = -13.2825374982512 +213000 ekin = 3.16826455951518 | erot = 2.38020171954861 | epot = -18.8310037775187 | etot = -13.2825374984549 +214000 ekin = 3.16489343854634 | erot = 2.4067605217501 | epot = -18.8541914589957 | etot = -13.2825374986993 +215000 ekin = 3.16566474352153 | erot = 2.4376973804056 | epot = -18.8858996228856 | etot = -13.2825374989585 +216000 ekin = 3.16936807503256 | erot = 2.47051711068081 | epot = -18.9224226849174 | etot = -13.282537499204 +217000 ekin = 3.16266988026838 | erot = 2.47868467134127 | epot = -18.9238920507831 | etot = -13.2825374991734 +218000 ekin = 3.17835235865319 | erot = 2.45704329444878 | epot = -18.9179331413792 | etot = -13.2825374882772 +219000 ekin = 3.26524817202019 | erot = 2.48120766962855 | epot = -19.0289933444494 | etot = -13.2825375028007 +220000 ekin = 3.31083663795614 | erot = 2.50602061547625 | epot = -19.0993947418608 | etot = -13.2825374884285 +221000 ekin = 3.33748530919716 | erot = 2.52276996124467 | epot = -19.1427927588607 | etot = -13.2825374884189 +222000 ekin = 3.36243211589499 | erot = 2.53668587910066 | epot = -19.181655483376 | etot = -13.2825374883803 +223000 ekin = 3.38541896904217 | erot = 2.54888617169842 | epot = -19.2168426290796 | etot = -13.282537488339 +224000 ekin = 3.40625812507986 | erot = 2.56049920868626 | epot = -19.2492948220809 | etot = -13.2825374883148 +225000 ekin = 3.42484722909618 | erot = 2.57234499865719 | epot = -19.2797297160695 | etot = -13.2825374883162 +226000 ekin = 3.44121067431411 | erot = 2.58472036633686 | epot = -19.3084685289968 | etot = -13.2825374883458 +227000 ekin = 3.45552721377379 | erot = 2.59730386680743 | epot = -19.3353685689834 | etot = -13.2825374884022 +228000 ekin = 3.46810974282139 | erot = 2.6091693120744 | epot = -19.3598165433777 | etot = -13.2825374884819 +229000 ekin = 3.4793267631311 | erot = 2.61888809507087 | epot = -19.3807523467836 | etot = -13.2825374885816 +230000 ekin = 3.48948003513645 | erot = 2.62469570471749 | epot = -19.3967132285507 | etot = -13.2825374886968 +231000 ekin = 3.49867242979377 | erot = 2.62469374220078 | epot = -19.4059036608153 | etot = -13.2825374888207 +232000 ekin = 3.50671171842654 | erot = 2.6170613032781 | epot = -19.4063105106474 | etot = -13.2825374889427 +233000 ekin = 3.51309701132125 | erot = 2.60026316425572 | epot = -19.395897664621 | etot = -13.2825374890441 +234000 ekin = 3.51712117494327 | erot = 2.5732608561 | epot = -19.3729195201406 | etot = -13.2825374890973 +235000 ekin = 3.51809173982137 | erot = 2.53573892922866 | epot = -19.3363681581185 | etot = -13.2825374890685 +236000 ekin = 3.51562949139304 | erot = 2.48833922691111 | epot = -19.2865062072295 | etot = -13.2825374889254 +237000 ekin = 3.50996386129235 | erot = 2.43285732073676 | epot = -19.2253586706787 | etot = -13.2825374886496 +238000 ekin = 3.50212794781253 | erot = 2.37232394343562 | epot = -19.1569893794952 | etot = -13.2825374882471 +239000 ekin = 3.49397580570111 | erot = 2.31089750062538 | epot = -19.0874107940787 | etot = -13.2825374877522 +240000 ekin = 3.48799489984455 | erot = 2.2535377170645 | epot = -19.0240701041318 | etot = -13.2825374872227 +241000 ekin = 3.4869474415209 | erot = 2.2054938684223 | epot = -18.9749787966723 | etot = -13.2825374867291 +242000 ekin = 3.49341769740518 | erot = 2.1716922310321 | epot = -18.9476474147781 | etot = -13.2825374863409 +243000 ekin = 3.50935803683834 | erot = 2.15612557817114 | epot = -18.9480211011257 | etot = -13.2825374861162 +244000 ekin = 3.53571412218956 | erot = 2.16133426987289 | epot = -18.979585878157 | etot = -13.2825374860946 +245000 ekin = 3.57218201231806 | erot = 2.18803987534361 | epot = -19.0427593739549 | etot = -13.2825374862933 +246000 ekin = 3.61712090977309 | erot = 2.23496626996945 | epot = -19.134624666449 | etot = -13.2825374867064 +247000 ekin = 3.66762313707197 | erot = 2.29886938892499 | epot = -19.2490300133012 | etot = -13.2825374873042 +248000 ekin = 3.7197330409766 | erot = 2.3747925366233 | epot = -19.377063065633 | etot = -13.2825374880331 +249000 ekin = 3.7687988475912 | erot = 2.45655776432188 | epot = -19.5078941007305 | etot = -13.2825374888175 +250000 ekin = 3.80993596354031 | erot = 2.53748030029899 | epot = -19.6299537534039 | etot = -13.2825374895646 +251000 ekin = 3.83856187827056 | erot = 2.61124537605178 | epot = -19.7323447445001 | etot = -13.2825374901778 +252000 ekin = 3.85094160348732 | erot = 2.67282602420842 | epot = -19.8063051182675 | etot = -13.2825374905717 +253000 ekin = 3.84466267221376 | erot = 2.71927370140095 | epot = -19.8464738643054 | etot = -13.2825374906907 +254000 ekin = 3.81895334833665 | erot = 2.75020964906229 | epot = -19.8517004879202 | etot = -13.2825374905212 +255000 ekin = 3.77477712370614 | erot = 2.76789565653814 | epot = -19.8252102703408 | etot = -13.2825374900966 +256000 ekin = 3.71467746908406 | erot = 2.77685421459328 | epot = -19.7740691731677 | etot = -13.2825374894904 +257000 ekin = 3.64239785971379 | erot = 2.78310854270386 | epot = -19.7080438912194 | etot = -13.2825374888018 +258000 ekin = 3.56234912666851 | erot = 2.79319020432263 | epot = -19.6380768191282 | etot = -13.2825374881371 +259000 ekin = 3.47902170398396 | erot = 2.81309489223268 | epot = -19.5746540838083 | etot = -13.2825374875917 +260000 ekin = 3.39644765746004 | erot = 2.84735592157315 | epot = -19.5263410662695 | etot = -13.2825374872363 +261000 ekin = 3.31779785755485 | erot = 2.89836390677654 | epot = -19.4986992514401 | etot = -13.2825374871087 +262000 ekin = 3.24516405277549 | erot = 2.96601202360082 | epot = -19.493713563585 | etot = -13.2825374872087 +263000 ekin = 3.17954694530476 | erot = 3.04771661067519 | epot = -19.509801043485 | etot = -13.2825374875051 +264000 ekin = 3.12100159498054 | erot = 3.13875568824872 | epot = -19.5422947711677 | etot = -13.2825374879384 +265000 ekin = 3.068909969511 | erot = 3.23291804297596 | epot = -19.5843655009193 | etot = -13.2825374884324 +266000 ekin = 3.02230555156861 | erot = 3.32335252530508 | epot = -19.6281955657834 | etot = -13.2825374889098 +267000 ekin = 2.98016989218859 | erot = 3.40345614747457 | epot = -19.6661635289715 | etot = -13.2825374893083 +268000 ekin = 2.94163501488609 | erot = 3.46763177350625 | epot = -19.6918042779853 | etot = -13.282537489593 +269000 ekin = 2.90604069318514 | erot = 3.51175626238839 | epot = -19.7003344453578 | etot = -13.2825374897842 +270000 ekin = 2.87284037255906 | erot = 3.53329819601916 | epot = -19.6886760584274 | etot = -13.2825374898492 +271000 ekin = 2.84156688817829 | erot = 3.53141495904851 | epot = -19.6555193370576 | etot = -13.2825374898308 +272000 ekin = 2.81169493920539 | erot = 3.50673144119823 | epot = -19.6009638701441 | etot = -13.2825374897405 +273000 ekin = 2.78262532285011 | erot = 3.46115906465197 | epot = -19.5263218770821 | etot = -13.28253748958 +274000 ekin = 2.7538098130557 | erot = 3.39781487150794 | epot = -19.4341621738894 | etot = -13.2825374893258 +275000 ekin = 2.72497357924299 | erot = 3.32097131772016 | epot = -19.3284823859418 | etot = -13.2825374889787 +276000 ekin = 2.69631002934824 | erot = 3.23585259467473 | epot = -19.2147001125792 | etot = -13.2825374885562 +277000 ekin = 2.66855210196767 | erot = 3.14826501869249 | epot = -19.0993546087625 | etot = -13.2825374881024 +278000 ekin = 2.64286719085242 | erot = 3.06403640806158 | epot = -18.9894410865919 | etot = -13.2825374876779 +279000 ekin = 2.6206102822317 | erot = 2.98836162249344 | epot = -18.8915093920683 | etot = -13.2825374873432 +280000 ekin = 2.60303022005365 | erot = 2.92520891289703 | epot = -18.810776620091 | etot = -13.2825374871403 +281000 ekin = 2.59103448458094 | erot = 2.87693253510625 | epot = -18.7505045067693 | etot = -13.2825374870821 +282000 ekin = 2.58508390620569 | erot = 2.84417540765416 | epot = -18.7117968010114 | etot = -13.2825374871516 +283000 ekin = 2.58523135936705 | erot = 2.82606103956356 | epot = -18.6938298862415 | etot = -13.2825374873109 +284000 ekin = 2.59126091870015 | erot = 2.82059473157549 | epot = -18.6943931377914 | etot = -13.2825374875157 +285000 ekin = 2.6028463107778 | erot = 2.82514472713204 | epot = -18.7105285256397 | etot = -13.2825374877299 +286000 ekin = 2.61964775973889 | erot = 2.83687342635821 | epot = -18.7390586740322 | etot = -13.2825374879351 +287000 ekin = 2.64167894317198 | erot = 2.8528506609398 | epot = -18.777067092287 | etot = -13.2825374881753 +288000 ekin = 2.6687167813722 | erot = 2.87022930110005 | epot = -18.8214835708729 | etot = -13.2825374884007 +289000 ekin = 2.69931643718217 | erot = 2.88698660758031 | epot = -18.8688405333603 | etot = -13.2825374885979 +290000 ekin = 2.73194963658564 | erot = 2.90163654912848 | epot = -18.91612367448 | etot = -13.2825374887658 +291000 ekin = 2.76502957907501 | erot = 2.91324911168725 | epot = -18.9608161796579 | etot = -13.2825374888956 +292000 ekin = 2.79700561900648 | erot = 2.92149576190988 | epot = -19.0010388698883 | etot = -13.282537488972 +293000 ekin = 2.82654239554718 | erot = 2.92669002283955 | epot = -19.0357699073658 | etot = -13.2825374889791 +294000 ekin = 2.85272969462388 | erot = 2.92951972788893 | epot = -19.0647869114596 | etot = -13.2825374889468 +295000 ekin = 2.87508597590098 | erot = 2.9311082644765 | epot = -19.0887317291891 | etot = -13.2825374888116 +296000 ekin = 2.89378047526675 | erot = 2.93349300132876 | epot = -19.1098109651873 | etot = -13.2825374885917 +297000 ekin = 2.90976516784938 | erot = 2.93912517174385 | epot = -19.1314278279134 | etot = -13.2825374883201 +298000 ekin = 2.92469477926692 | erot = 2.95047845944716 | epot = -19.1577107267524 | etot = -13.2825374880383 +299000 ekin = 2.94065805823336 | erot = 2.96967690612592 | epot = -19.1928724521541 | etot = -13.2825374877948 +300000 ekin = 2.95980003469262 | erot = 2.99812642992008 | epot = -19.2404639522493 | etot = -13.2825374876367 +301000 ekin = 2.98391272977048 | erot = 3.03621252497702 | epot = -19.302662742346 | etot = -13.2825374875985 +302000 ekin = 3.01408971368422 | erot = 3.08312901018064 | epot = -19.3797562115572 | etot = -13.2825374876923 +303000 ekin = 3.05053302665408 | erot = 3.13689255668996 | epot = -19.4699630712472 | etot = -13.2825374879032 +304000 ekin = 3.08584972584671 | erot = 3.19556015974062 | epot = -19.5639473752475 | etot = -13.2825374896602 +305000 ekin = 3.11890909070302 | erot = 3.26281224727061 | epot = -19.6642588266132 | etot = -13.2825374886396 +306000 ekin = 3.16699270587545 | erot = 3.33070506272287 | epot = -19.7802352601681 | etot = -13.2825374915697 +307000 ekin = 3.22023032257278 | erot = 3.3799777181515 | epot = -19.8827455298064 | etot = -13.2825374890821 +308000 ekin = 3.27268739663165 | erot = 3.41969099128438 | epot = -19.9749158771467 | etot = -13.2825374892307 +309000 ekin = 3.32280425481028 | erot = 3.44976402097079 | epot = -20.0551057651176 | etot = -13.2825374893365 +310000 ekin = 3.36903652740728 | erot = 3.46970323071463 | epot = -20.1212772475588 | etot = -13.2825374894369 +311000 ekin = 3.40972253534196 | erot = 3.47940229944893 | epot = -20.1716623243582 | etot = -13.2825374895673 +312000 ekin = 3.44308129108907 | erot = 3.47898447382754 | epot = -20.204603254423 | etot = -13.2825374895064 +313000 ekin = 3.46879202758663 | erot = 3.47087869840748 | epot = -20.2222082156487 | etot = -13.2825374896546 +314000 ekin = 3.48565385463278 | erot = 3.45582059749242 | epot = -20.2240119419355 | etot = -13.2825374898103 +315000 ekin = 3.4921631329082 | erot = 3.43373104094955 | epot = -20.2084316637809 | etot = -13.2825374899231 +316000 ekin = 3.48736213303232 | erot = 3.40482567255629 | epot = -20.1747252955269 | etot = -13.2825374899383 +317000 ekin = 3.46994132507374 | erot = 3.36841330847356 | epot = -20.1208921250387 | etot = -13.2825374914914 +318000 ekin = 3.43614022048189 | erot = 3.32066657788102 | epot = -20.0393442896713 | etot = -13.2825374913084 +319000 ekin = 3.38694293952315 | erot = 3.2636491069797 | epot = -19.9331295374394 | etot = -13.2825374909366 +320000 ekin = 3.32506744212965 | erot = 3.20113650606275 | epot = -19.8087414386365 | etot = -13.2825374904441 +321000 ekin = 3.25415482891539 | erot = 3.13766117542953 | epot = -19.6743534942655 | etot = -13.2825374899206 +322000 ekin = 3.17813669787398 | erot = 3.07780020747378 | epot = -19.5384743947986 | etot = -13.2825374894508 +323000 ekin = 3.10066688252112 | erot = 3.02549088180775 | epot = -19.4086952534164 | etot = -13.2825374890875 +324000 ekin = 3.02479637479555 | erot = 2.9835512249436 | epot = -19.2908850885836 | etot = -13.2825374888444 +325000 ekin = 2.95294332411579 | erot = 2.95347420684863 | epot = -19.1889550196703 | etot = -13.2825374887059 +326000 ekin = 2.88706743998012 | erot = 2.93544936652532 | epot = -19.1050542951527 | etot = -13.2825374886473 +327000 ekin = 2.82887581625042 | erot = 2.92851219862423 | epot = -19.0399255035249 | etot = -13.2825374886502 +328000 ekin = 2.7799083006856 | erot = 2.93074772300673 | epot = -18.9931935123989 | etot = -13.2825374887065 +329000 ekin = 2.74145002280429 | erot = 2.93954016638564 | epot = -18.9635276780016 | etot = -13.2825374888116 +330000 ekin = 2.71432845550724 | erot = 2.95189909643594 | epot = -18.9487650408976 | etot = -13.2825374889545 +331000 ekin = 2.69870867088015 | erot = 2.96486608415783 | epot = -18.9461122441539 | etot = -13.2825374891159 +332000 ekin = 2.69398517733071 | erot = 2.9759351218084 | epot = -18.9524577884139 | etot = -13.2825374892748 +333000 ekin = 2.69881348537833 | erot = 2.98337443171614 | epot = -18.9647254065077 | etot = -13.2825374894133 +334000 ekin = 2.71127609678656 | erot = 2.98637176000363 | epot = -18.9801853463082 | etot = -13.282537489518 +335000 ekin = 2.72916096430101 | erot = 2.98501165510017 | epot = -18.9967101089767 | etot = -13.2825374895756 +336000 ekin = 2.75032164400955 | erot = 2.98016551096549 | epot = -19.0130246445444 | etot = -13.2825374895694 +337000 ekin = 2.77304615866171 | erot = 2.97336445321275 | epot = -19.0289481013653 | etot = -13.2825374894909 +338000 ekin = 2.79631213711555 | erot = 2.96664518651948 | epot = -19.0454948129873 | etot = -13.2825374893522 +339000 ekin = 2.8198251309544 | erot = 2.96230352229863 | epot = -19.0646661424453 | etot = -13.2825374891923 +340000 ekin = 2.84381599358249 | erot = 2.96250923740561 | epot = -19.0888627200583 | etot = -13.2825374890702 +341000 ekin = 2.86861716322249 | erot = 2.96879944354184 | epot = -19.1199540958278 | etot = -13.2825374890635 +342000 ekin = 2.8942330530754 | erot = 2.98159830919509 | epot = -19.1583688514537 | etot = -13.2825374891832 +343000 ekin = 2.92230469127443 | erot = 3.00151195978065 | epot = -19.2063541396099 | etot = -13.2825374885548 +344000 ekin = 2.95328542678957 | erot = 3.02739469587516 | epot = -19.2632176118817 | etot = -13.282537489217 +345000 ekin = 2.98288076792584 | erot = 3.05397730230856 | epot = -19.3193955601209 | etot = -13.2825374898865 +346000 ekin = 3.0068362280629 | erot = 3.07579634903275 | epot = -19.3651700675335 | etot = -13.2825374904379 +347000 ekin = 3.021682039197 | erot = 3.0883226978178 | epot = -19.3925422277954 | etot = -13.2825374907806 +348000 ekin = 3.02528371459214 | erot = 3.08873432783574 | epot = -19.3965555333152 | etot = -13.2825374908873 +349000 ekin = 3.01708434471769 | erot = 3.07610751269362 | epot = -19.3757293482008 | etot = -13.2825374907895 +350000 ekin = 2.99803087494402 | erot = 3.05108999688533 | epot = -19.3316583623752 | etot = -13.2825374905459 +351000 ekin = 2.97033325354314 | erot = 3.01539362128504 | epot = -19.268264365027 | etot = -13.2825374901988 +352000 ekin = 2.93755453890544 | erot = 2.97175102427381 | epot = -19.1918430529999 | etot = -13.2825374898207 +353000 ekin = 2.90330530001813 | erot = 2.92291261114237 | epot = -19.1087554005693 | etot = -13.2825374894088 +354000 ekin = 2.87126755833568 | erot = 2.87170321125813 | epot = -19.0255082585641 | etot = -13.2825374889703 +355000 ekin = 2.84520639660643 | erot = 2.82119115452776 | epot = -18.948935039652 | etot = -13.2825374885178 +356000 ekin = 2.8287863971603 | erot = 2.7746321329023 | epot = -18.8859560181437 | etot = -13.2825374880811 +357000 ekin = 2.82589501110754 | erot = 2.73507904234615 | epot = -18.8435115424282 | etot = -13.2825374889745 +358000 ekin = 2.83567543256197 | erot = 2.6999034357179 | epot = -18.8181163574566 | etot = -13.2825374891768 +359000 ekin = 2.85413863003174 | erot = 2.66477535390921 | epot = -18.8014514734662 | etot = -13.2825374895252 +360000 ekin = 2.87797108635824 | erot = 2.62716069413401 | epot = -18.7876692705271 | etot = -13.2825374900349 +361000 ekin = 2.90295419334403 | erot = 2.58324525246715 | epot = -18.7687369364404 | etot = -13.2825374906292 +362000 ekin = 2.92446718933308 | erot = 2.52862237257544 | epot = -18.7356270530351 | etot = -13.2825374911266 +363000 ekin = 2.93848759933348 | erot = 2.45989164640849 | epot = -18.680916737042 | etot = -13.2825374913 +364000 ekin = 2.94271150164586 | erot = 2.37661313123214 | epot = -18.6018621239955 | etot = -13.2825374911175 +365000 ekin = 2.93600170081438 | erot = 2.28250131433965 | epot = -18.5010405056253 | etot = -13.2825374904713 +366000 ekin = 2.91934189957478 | erot = 2.18525996401368 | epot = -18.3871393531652 | etot = -13.2825374895768 +367000 ekin = 2.89548895825519 | erot = 2.0946888564492 | epot = -18.2727153033882 | etot = -13.2825374886839 +368000 ekin = 2.86763306547926 | erot = 2.02026878405327 | epot = -18.1704393375192 | etot = -13.2825374879867 +369000 ekin = 2.83845106986046 | erot = 1.96931673436804 | epot = -18.0903052917965 | etot = -13.282537487568 +370000 ekin = 2.80963551309284 | erot = 1.94618455936313 | epot = -18.0383575598705 | etot = -13.2825374874145 +371000 ekin = 2.78188668089849 | erot = 1.95235490032645 | epot = -18.0167790686888 | etot = -13.2825374874639 +372000 ekin = 2.75518266190993 | erot = 1.98699478725745 | epot = -18.0247149368147 | etot = -13.2825374876473 +373000 ekin = 2.7291288052834 | erot = 2.04757125854604 | epot = -18.0592375517431 | etot = -13.2825374879136 +374000 ekin = 2.7032481730965 | erot = 2.13030562163268 | epot = -18.1160912829679 | etot = -13.2825374882387 +375000 ekin = 2.67714701016873 | erot = 2.23039820126271 | epot = -18.1900827000525 | etot = -13.282537488621 +376000 ekin = 2.65054772278943 | erot = 2.34206662745006 | epot = -18.2751518393106 | etot = -13.2825374890711 +377000 ekin = 2.62322866602789 | erot = 2.45852983339147 | epot = -18.3642959890092 | etot = -13.2825374895898 +378000 ekin = 2.59495135704074 | erot = 2.57214449993232 | epot = -18.4496333471184 | etot = -13.2825374901453 +379000 ekin = 2.56546707826881 | erot = 2.67491697597423 | epot = -18.522921544903 | etot = -13.2825374906599 +380000 ekin = 2.53466143096452 | erot = 2.75950320018323 | epot = -18.5767021221686 | etot = -13.2825374910209 +381000 ekin = 2.50280930121905 | erot = 2.82054519918234 | epot = -18.605891991525 | etot = -13.2825374911236 +382000 ekin = 2.47081272773286 | erot = 2.85587907290837 | epot = -18.6092292915673 | etot = -13.2825374909261 +383000 ekin = 2.44026108011578 | erot = 2.86702983653801 | epot = -18.5898284071325 | etot = -13.2825374904788 +384000 ekin = 2.41324034479873 | erot = 2.85867137365971 | epot = -18.5544492083626 | etot = -13.2825374899041 +385000 ekin = 2.3919736779495 | erot = 2.83724859058569 | epot = -18.5117597578745 | etot = -13.2825374893393 +386000 ekin = 2.37848037079693 | erot = 2.80936838549168 | epot = -18.4703862451677 | etot = -13.2825374888791 +387000 ekin = 2.37440773877138 | erot = 2.78057799551461 | epot = -18.4375232228406 | etot = -13.2825374885547 +388000 ekin = 2.38106033998944 | erot = 2.75482980994152 | epot = -18.4184276382777 | etot = -13.2825374883468 +389000 ekin = 2.3995269472836 | erot = 2.73455852133737 | epot = -18.4166229568386 | etot = -13.2825374882176 +390000 ekin = 2.43075796801538 | erot = 2.72108399953604 | epot = -18.4343794556925 | etot = -13.2825374881411 +391000 ekin = 2.47547758104125 | erot = 2.71503282252802 | epot = -18.4730478916894 | etot = -13.2825374881201 +392000 ekin = 2.53389941336301 | erot = 2.71657607916961 | epot = -18.5330129807166 | etot = -13.282537488184 +393000 ekin = 2.60531467139514 | erot = 2.72543162367145 | epot = -18.6132837834377 | etot = -13.2825374883712 +394000 ekin = 2.68770614221053 | erot = 2.74072420161599 | epot = -18.710967832529 | etot = -13.2825374887024 +395000 ekin = 2.77757589910946 | erot = 2.76089277951269 | epot = -18.821006167779 | etot = -13.2825374891568 +396000 ekin = 2.87012638573289 | erot = 2.78383015196004 | epot = -18.9364940273591 | etot = -13.2825374896661 +397000 ekin = 2.95979968456986 | erot = 2.80730760068458 | epot = -19.0496447753932 | etot = -13.2825374901387 +398000 ekin = 3.04101675292502 | erot = 2.82953067572591 | epot = -19.1530849191498 | etot = -13.2825374904989 +399000 ekin = 3.10335323687934 | erot = 2.84223393462917 | epot = -19.2281247208206 | etot = -13.2825375493121 +400000 ekin = 3.10435999781796 | erot = 2.68059016642954 | epot = -19.0674876235022 | etot = -13.2825374592547 +401000 ekin = 3.39309095570315 | erot = 2.63997900103007 | epot = -19.3156074940371 | etot = -13.2825375373039 +402000 ekin = 3.44106634979645 | erot = 2.659790716706 | epot = -19.3833945765517 | etot = -13.2825375100493 +403000 ekin = 3.43207406397009 | erot = 2.67998452069831 | epot = -19.394596094653 | etot = -13.2825375099846 +404000 ekin = 3.40426891789311 | erot = 2.70237957195789 | epot = -19.3891859997632 | etot = -13.2825375099122 +405000 ekin = 3.3593347341666 | erot = 2.72607645467142 | epot = -19.367948698657 | etot = -13.282537509819 +406000 ekin = 3.29966540905146 | erot = 2.74995079993995 | epot = -19.3321537186901 | etot = -13.2825375096987 +407000 ekin = 3.2282311798008 | erot = 2.77286165525633 | epot = -19.2836303446157 | etot = -13.2825375095586 +408000 ekin = 3.1483591073718 | erot = 2.79373949027867 | epot = -19.2246361070933 | etot = -13.2825375094428 +409000 ekin = 3.06351542881959 | erot = 2.81131469884056 | epot = -19.1573676369638 | etot = -13.2825375093037 +410000 ekin = 2.97699949579686 | erot = 2.82462679197841 | epot = -19.0841637969767 | etot = -13.2825375092014 +411000 ekin = 2.89165449989684 | erot = 2.83289882075493 | epot = -19.0070908297837 | etot = -13.2825375091319 +412000 ekin = 2.80978906687504 | erot = 2.83549592230531 | epot = -18.9278224982521 | etot = -13.2825375090718 +413000 ekin = 2.73325536965585 | erot = 2.83215388787228 | epot = -18.8479467665131 | etot = -13.282537508985 +414000 ekin = 2.66364879696115 | erot = 2.82325639291671 | epot = -18.7694426987162 | etot = -13.2825375088383 +415000 ekin = 2.60253860597198 | erot = 2.81004531899789 | epot = -18.6951214335864 | etot = -13.2825375086165 +416000 ekin = 2.55161661471215 | erot = 2.7946463118532 | epot = -18.6288004349012 | etot = -13.2825375083358 +417000 ekin = 2.51265407611577 | erot = 2.77984605489432 | epot = -18.5750376413434 | etot = -13.2825375103333 +418000 ekin = 2.47334604007925 | erot = 2.77799997552572 | epot = -18.5338835235875 | etot = -13.2825375079825 +419000 ekin = 2.44559608969893 | erot = 2.79655231012718 | epot = -18.5246859081463 | etot = -13.2825375083202 +420000 ekin = 2.44884495813904 | erot = 2.81276776866598 | epot = -18.5441502345702 | etot = -13.2825375077651 +421000 ekin = 2.47134322854002 | erot = 2.82756585669941 | epot = -18.5814465933144 | etot = -13.2825375080749 +422000 ekin = 2.50522487694504 | erot = 2.84806830842347 | epot = -18.6358306938984 | etot = -13.2825375085299 +423000 ekin = 2.54673540365736 | erot = 2.87162843047175 | epot = -18.7009013431671 | etot = -13.282537509038 +424000 ekin = 2.5915545267989 | erot = 2.89540834353031 | epot = -18.7695003798181 | etot = -13.2825375094888 +425000 ekin = 2.63549518712503 | erot = 2.9172494646209 | epot = -18.8352821615391 | etot = -13.2825375097932 +426000 ekin = 2.67515430284032 | erot = 2.93632167691171 | epot = -18.8940134896611 | etot = -13.2825375099091 +427000 ekin = 2.70835356711895 | erot = 2.95332774897864 | epot = -18.9442188259411 | etot = -13.2825375098435 +428000 ekin = 2.73429370857904 | erot = 2.97029523905205 | epot = -18.9871264572657 | etot = -13.2825375096346 +429000 ekin = 2.75344687778548 | erot = 2.99015713231241 | epot = -19.026141519429 | etot = -13.2825375093311 +430000 ekin = 2.76726512076715 | erot = 3.01631311484004 | epot = -19.0661157445923 | etot = -13.2825375089851 +431000 ekin = 2.77776520584482 | erot = 3.05220345439827 | epot = -19.1125061689064 | etot = -13.2825375086633 +432000 ekin = 2.78700254672782 | erot = 3.10077153004471 | epot = -19.1703115852294 | etot = -13.2825375084569 +433000 ekin = 2.79644099946406 | erot = 3.16368547122764 | epot = -19.2426639791689 | etot = -13.2825375084772 +434000 ekin = 2.8062952810192 | erot = 3.24036053939458 | epot = -19.3291933292362 | etot = -13.2825375088224 +435000 ekin = 2.81503854863169 | erot = 3.32707633256549 | epot = -19.4246523907207 | etot = -13.2825375095236 +436000 ekin = 2.81936003428183 | erot = 3.41666372807462 | epot = -19.5185612728498 | etot = -13.2825375104934 +437000 ekin = 2.81480689571151 | erot = 3.49920681099962 | epot = -19.5965512182294 | etot = -13.2825375115182 +438000 ekin = 2.79709037800121 | erot = 3.56380823492809 | epot = -19.643436125261 | etot = -13.2825375123317 +439000 ekin = 2.76357573484572 | erot = 3.60097663047473 | epot = -19.6470898780363 | etot = -13.2825375127159 +440000 ekin = 2.71419714341371 | erot = 3.6047593537822 | epot = -19.6014940098261 | etot = -13.2825375126302 +441000 ekin = 2.65147586146338 | erot = 3.57350682801194 | epot = -19.5075202016436 | etot = -13.2825375121683 +442000 ekin = 2.57978868207942 | erot = 3.50949061111828 | epot = -19.3718168046656 | etot = -13.2825375114679 +443000 ekin = 2.50456558754104 | erot = 3.4178674196423 | epot = -19.2049705178168 | etot = -13.2825375106335 +444000 ekin = 2.43185299049922 | erot = 3.30558723792078 | epot = -19.0199777381447 | etot = -13.2825375097247 +445000 ekin = 2.36817510309063 | erot = 3.18052048207573 | epot = -18.8312330939526 | etot = -13.2825375087862 +446000 ekin = 2.32036350430527 | erot = 3.05081891044131 | epot = -18.6537199226123 | etot = -13.2825375078657 +447000 ekin = 2.29507009387958 | erot = 2.92434156859069 | epot = -18.5019491695481 | etot = -13.2825375070778 +448000 ekin = 2.29792306265903 | erot = 2.80795199471116 | epot = -18.3884125638822 | etot = -13.282537506512 +449000 ekin = 2.33256968728525 | erot = 2.7069587718453 | epot = -18.3220659653954 | etot = -13.2825375062648 +450000 ekin = 2.39980570006764 | erot = 2.6245346844449 | epot = -18.3068778909135 | etot = -13.282537506401 +451000 ekin = 2.49706752601175 | erot = 2.56128240620743 | epot = -18.3408874391531 | etot = -13.2825375069339 +452000 ekin = 2.61842576959501 | erot = 2.51510244034445 | epot = -18.4160657177213 | etot = -13.2825375077819 +453000 ekin = 2.75505822099958 | erot = 2.48156991528656 | epot = -18.5191656452411 | etot = -13.2825375089549 +454000 ekin = 2.89583245290297 | erot = 2.45420794646339 | epot = -18.6325779096657 | etot = -13.2825375102994 +455000 ekin = 3.02803920576056 | erot = 2.42568753016163 | epot = -18.736264247583 | etot = -13.2825375116608 +456000 ekin = 3.13847091959985 | erot = 2.38932191986942 | epot = -18.8103303522404 | etot = -13.2825375127711 +457000 ekin = 3.21547363215232 | erot = 2.34093725374963 | epot = -18.83894839917 | etot = -13.2825375132681 +458000 ekin = 3.2519255085167 | erot = 2.28077893487382 | epot = -18.8152419562951 | etot = -13.2825375129046 +459000 ekin = 3.24761130320326 | erot = 2.21429904484092 | epot = -18.744447859815 | etot = -13.2825375117708 +460000 ekin = 3.20922400634736 | erot = 2.15086461860742 | epot = -18.6426261352081 | etot = -13.2825375102533 +461000 ekin = 3.14796311215653 | erot = 2.10092694607039 | epot = -18.5314275670048 | etot = -13.2825375087779 +462000 ekin = 3.07634336775073 | erot = 2.07329933806439 | epot = -18.4321802134279 | etot = -13.2825375076128 +463000 ekin = 3.00570913413418 | erot = 2.07367404520667 | epot = -18.3619206861977 | etot = -13.2825375068568 +464000 ekin = 2.9448582997097 | erot = 2.10431183996111 | epot = -18.331707646191 | etot = -13.2825375065202 +465000 ekin = 2.89946798284609 | erot = 2.16425406354561 | epot = -18.3462595529816 | etot = -13.2825375065899 +466000 ekin = 2.87195252749972 | erot = 2.24955307487499 | epot = -18.4040431094255 | etot = -13.2825375070508 +467000 ekin = 2.86158324930207 | erot = 2.3533892427293 | epot = -18.4975099999046 | etot = -13.2825375078732 +468000 ekin = 2.86493243611993 | erot = 2.46640127706619 | epot = -18.6138712219846 | etot = -13.2825375087985 +469000 ekin = 2.87700241085747 | erot = 2.57824581694139 | epot = -18.7377857379035 | etot = -13.2825375101046 +470000 ekin = 2.89115454215414 | erot = 2.67606199010798 | epot = -18.8497540435902 | etot = -13.2825375113281 +471000 ekin = 2.90087699699085 | erot = 2.74765202467846 | epot = -18.9310665338721 | etot = -13.2825375122028 +472000 ekin = 2.90129360656583 | erot = 2.7844228810356 | epot = -18.9682540001117 | etot = -13.2825375125102 +473000 ekin = 2.89014262487726 | erot = 2.78350866545128 | epot = -18.9561888025163 | etot = -13.2825375121877 +474000 ekin = 2.8679845551896 | erot = 2.74843722225596 | epot = -18.8989592888163 | etot = -13.2825375113708 +475000 ekin = 2.83751222123126 | erot = 2.68789202057427 | epot = -18.8079417521389 | etot = -13.2825375103333 +476000 ekin = 2.80225697256743 | erot = 2.61311305367502 | epot = -18.6979075356038 | etot = -13.2825375093613 +477000 ekin = 2.76525060538535 | erot = 2.53510543119006 | epot = -18.5828935452222 | etot = -13.2825375086468 +478000 ekin = 2.72814283271883 | erot = 2.46266477167839 | epot = -18.4733451126463 | etot = -13.282537508249 +479000 ekin = 2.69099471858041 | erot = 2.40160392945098 | epot = -18.375136156148 | etot = -13.2825375081166 +480000 ekin = 2.6526681049776 | erot = 2.35496214915731 | epot = -18.2901677623243 | etot = -13.2825375081894 +481000 ekin = 2.611442355162 | erot = 2.32364519373677 | epot = -18.2176250571627 | etot = -13.282537508264 +482000 ekin = 2.565776730153 | erot = 2.30767778316155 | epot = -18.1559920216392 | etot = -13.2825375083247 +483000 ekin = 2.51481850308162 | erot = 2.30660853349362 | epot = -18.1039645449013 | etot = -13.2825375083261 +484000 ekin = 2.45838132863017 | erot = 2.3198450068296 | epot = -18.0607638434524 | etot = -13.2825375079926 +485000 ekin = 2.37536403481855 | erot = 2.30798475223331 | epot = -17.9658863029946 | etot = -13.2825375159427 +486000 ekin = 2.31029787369058 | erot = 2.27486987654653 | epot = -17.8677052455649 | etot = -13.2825374953278 +487000 ekin = 2.35903895728042 | erot = 2.35840823831765 | epot = -17.9999847156837 | etot = -13.2825375200856 +488000 ekin = 2.35207405535098 | erot = 2.45495770508831 | epot = -18.0895692764695 | etot = -13.2825375160302 +489000 ekin = 2.32025825397052 | erot = 2.54616767539779 | epot = -18.1489634454364 | etot = -13.2825375160681 +490000 ekin = 2.29515153869984 | erot = 2.64227715696153 | epot = -18.2199662119964 | etot = -13.282537516335 +491000 ekin = 2.27724499850078 | erot = 2.73950547060331 | epot = -18.2992879857125 | etot = -13.2825375166084 +492000 ekin = 2.26670396937252 | erot = 2.83351832936053 | epot = -18.3827598156682 | etot = -13.2825375169351 +493000 ekin = 2.26314468317306 | erot = 2.91977614251813 | epot = -18.4654583429642 | etot = -13.282537517273 +494000 ekin = 2.26577113863215 | erot = 2.99399214332928 | epot = -18.5423007995401 | etot = -13.2825375175787 +495000 ekin = 2.27355094493377 | erot = 3.05259857144223 | epot = -18.6086870341908 | etot = -13.2825375178148 +496000 ekin = 2.28538641733465 | erot = 3.09313022185941 | epot = -18.661054157153 | etot = -13.282537517959 +497000 ekin = 2.3002347482521 | erot = 3.11444072103781 | epot = -18.6972129872905 | etot = -13.2825375180006 +498000 ekin = 2.31719365941364 | erot = 3.11678508297333 | epot = -18.7165162603266 | etot = -13.2825375179397 +499000 ekin = 2.33554254163157 | erot = 3.10178716717433 | epot = -18.7198672265901 | etot = -13.2825375177842 +500000 ekin = 2.31317350075609 | erot = 3.05449093052383 | epot = -18.6502019679387 | etot = -13.2825375366588 +501000 ekin = 2.31231722963358 | erot = 3.00810318070389 | epot = -18.6029579370661 | etot = -13.2825375267286 +502000 ekin = 2.38999638954889 | erot = 2.98467042895374 | epot = -18.657204342138 | etot = -13.2825375236353 +503000 ekin = 2.41312387634462 | erot = 2.93091691360098 | epot = -18.6265783132937 | etot = -13.2825375233481 +504000 ekin = 2.43600229238282 | erot = 2.88130858484448 | epot = -18.5998484003617 | etot = -13.2825375231344 +505000 ekin = 2.45757791197103 | erot = 2.84011866669662 | epot = -18.5802341017161 | etot = -13.2825375230484 +506000 ekin = 2.47627134224707 | erot = 2.81025901810999 | epot = -18.5690678834978 | etot = -13.2825375231408 +507000 ekin = 2.48985246050729 | erot = 2.79268587937519 | epot = -18.5650758633262 | etot = -13.2825375234437 +508000 ekin = 2.49542483825231 | erot = 2.78597986942009 | epot = -18.5639422316207 | etot = -13.2825375239483 +509000 ekin = 2.48963204749862 | erot = 2.78630577999958 | epot = -18.5584753520799 | etot = -13.2825375245818 +510000 ekin = 2.46917438876006 | erot = 2.78796571286371 | epot = -18.5396776268285 | etot = -13.2825375252047 +511000 ekin = 2.43159454916956 | erot = 2.78459744700141 | epot = -18.4987295218192 | etot = -13.2825375256482 +512000 ekin = 2.37609227914812 | erot = 2.7707369794783 | epot = -18.4293667844085 | etot = -13.2825375257821 +513000 ekin = 2.30402039320529 | erot = 2.74317280239451 | epot = -18.3297307211707 | etot = -13.2825375255709 +514000 ekin = 2.21884081240883 | erot = 2.70155414867794 | epot = -18.2029324861636 | etot = -13.2825375250768 +515000 ekin = 2.12561338169144 | erot = 2.64810551844221 | epot = -18.0562564245494 | etot = -13.2825375244158 +516000 ekin = 2.0302995856451 | erot = 2.5867398599196 | epot = -17.8995769692659 | etot = -13.2825375237012 +517000 ekin = 1.93914577194817 | erot = 2.52206054313542 | epot = -17.7437438380945 | etot = -13.2825375230109 +518000 ekin = 1.85826662411615 | erot = 2.45858700715108 | epot = -17.5993911536592 | etot = -13.2825375223919 +519000 ekin = 1.79333215324367 | erot = 2.40035341708211 | epot = -17.4762230921876 | etot = -13.2825375218619 +520000 ekin = 1.74929005168975 | erot = 2.35078235676691 | epot = -17.3826099298929 | etot = -13.2825375214363 +521000 ekin = 1.73007209345073 | erot = 2.31266171840817 | epot = -17.3252713329969 | etot = -13.282537521138 +522000 ekin = 1.73822781682595 | erot = 2.2881155718937 | epot = -17.3088809097143 | etot = -13.2825375209947 +523000 ekin = 1.77456624772603 | erot = 2.2785083458307 | epot = -17.3356121145903 | etot = -13.2825375210336 +524000 ekin = 1.83790458514344 | erot = 2.28429322274723 | epot = -17.4047353291616 | etot = -13.2825375212709 +525000 ekin = 1.92500868748296 | erot = 2.30484700359195 | epot = -17.5123932127819 | etot = -13.282537521707 +526000 ekin = 2.0307578025818 | erot = 2.33833465322601 | epot = -17.651629978134 | etot = -13.2825375223262 +527000 ekin = 2.14850843905356 | erot = 2.38164040104833 | epot = -17.8126863631983 | etot = -13.2825375230964 +528000 ekin = 2.27060096649051 | erot = 2.43041424715665 | epot = -17.9835527376135 | etot = -13.2825375239663 +529000 ekin = 2.38896012863249 | erot = 2.4793138751117 | epot = -18.1508115286032 | etot = -13.282537524859 +530000 ekin = 2.49576940535655 | erot = 2.52254117021849 | epot = -18.3008481012414 | etot = -13.2825375256663 +531000 ekin = 2.58420744220974 | erot = 2.55472238426385 | epot = -18.4214673527334 | etot = -13.2825375262598 +532000 ekin = 2.64918587017627 | erot = 2.57201883162556 | epot = -18.5037422283274 | etot = -13.2825375265255 +533000 ekin = 2.68793333155572 | erot = 2.57313230810709 | epot = -18.5436031660763 | etot = -13.2825375264134 +534000 ekin = 2.70021208216117 | erot = 2.55975253147949 | epot = -18.542502139612 | etot = -13.2825375259714 +535000 ekin = 2.68802701634936 | erot = 2.53615014862128 | epot = -18.5067146903044 | etot = -13.2825375253337 +536000 ekin = 2.65489019113449 | erot = 2.50801671125187 | epot = -18.445444427055 | etot = -13.2825375246686 +537000 ekin = 2.60490332065097 | erot = 2.48102333788784 | epot = -18.3684641826523 | etot = -13.2825375241135 +538000 ekin = 2.54198784537002 | erot = 2.45965628961172 | epot = -18.2841816579271 | etot = -13.2825375229454 +539000 ekin = 2.47150013366557 | erot = 2.44756195583901 | epot = -18.2015996124771 | etot = -13.2825375229725 +540000 ekin = 2.39647534126896 | erot = 2.4452543590462 | epot = -18.1242672233716 | etot = -13.2825375230564 +541000 ekin = 2.31786635168338 | erot = 2.45130088253407 | epot = -18.0517047573377 | etot = -13.2825375231202 +542000 ekin = 2.23702678132889 | erot = 2.4642388816219 | epot = -17.983803186044 | etot = -13.2825375230932 +543000 ekin = 2.15612181951174 | erot = 2.483136674149 | epot = -17.9217960165952 | etot = -13.2825375229345 +544000 ekin = 2.07836492819822 | erot = 2.50789688708103 | epot = -17.8687993379301 | etot = -13.2825375226508 +545000 ekin = 2.00794258372951 | erot = 2.53918840886296 | epot = -17.8296685148941 | etot = -13.2825375223016 +546000 ekin = 1.94957099412975 | erot = 2.578008196098 | epot = -17.8101167122069 | etot = -13.2825375219791 +547000 ekin = 1.9077624243153 | erot = 2.62501532097517 | epot = -17.8153152670783 | etot = -13.2825375217878 +548000 ekin = 1.88600984710573 | erot = 2.67988146408135 | epot = -17.8484288329841 | etot = -13.282537521797 +549000 ekin = 1.88615242689691 | erot = 2.74090375620349 | epot = -17.909593705124 | etot = -13.2825375220236 +550000 ekin = 1.90811801080135 | erot = 2.80501593005898 | epot = -17.9956714632894 | etot = -13.282537522429 +551000 ekin = 1.95008337623402 | erot = 2.86816804419082 | epot = -18.1007889433658 | etot = -13.2825375229409 +552000 ekin = 2.00893649351174 | erot = 2.92590890426342 | epot = -18.2173829212562 | etot = -13.282537523481 +553000 ekin = 2.08084803911103 | erot = 2.97396311008449 | epot = -18.3373486731828 | etot = -13.2825375239872 +554000 ekin = 2.16178844742615 | erot = 3.00865361313796 | epot = -18.4529795849852 | etot = -13.2825375244211 +555000 ekin = 2.24792031030894 | erot = 3.02713377648476 | epot = -18.5575916115531 | etot = -13.2825375247594 +556000 ekin = 2.3358895304738 | erot = 3.02749801445229 | epot = -18.6459250699077 | etot = -13.2825375249816 +557000 ekin = 2.42273135018697 | erot = 3.00799378133903 | epot = -18.7132626568713 | etot = -13.2825375253453 +558000 ekin = 2.50467530619079 | erot = 2.96457109807151 | epot = -18.7517839296409 | etot = -13.2825375253786 +559000 ekin = 2.57989829547792 | erot = 2.89795083547094 | epot = -18.7603866561117 | etot = -13.2825375251628 +560000 ekin = 2.64819333040997 | erot = 2.8115011418383 | epot = -18.7422319969952 | etot = -13.282537524747 +561000 ekin = 2.71041014716014 | erot = 2.71050571090859 | epot = -18.7034533823107 | etot = -13.282537524242 +562000 ekin = 2.76764108184349 | erot = 2.60142670481719 | epot = -18.6516053104339 | etot = -13.2825375237732 +563000 ekin = 2.82041332178183 | erot = 2.49094539995269 | epot = -18.5938962451522 | etot = -13.2825375234177 +564000 ekin = 2.86835957176528 | erot = 2.38512022706598 | epot = -18.5360173220094 | etot = -13.2825375231781 +565000 ekin = 2.9105055625117 | erot = 2.2888699309895 | epot = -18.4819130165188 | etot = -13.2825375230176 +566000 ekin = 2.9458361953691 | erot = 2.20572382108587 | epot = -18.4340975393717 | etot = -13.2825375229167 +567000 ekin = 2.97364576057443 | erot = 2.13764971279795 | epot = -18.3938329962642 | etot = -13.2825375228919 +568000 ekin = 2.99348659092395 | erot = 2.08490808290625 | epot = -18.3609321968044 | etot = -13.2825375229742 +569000 ekin = 3.00487691648673 | erot = 2.04604350391468 | epot = -18.3334579435673 | etot = -13.2825375231659 +570000 ekin = 3.00710556183365 | erot = 2.01819764938775 | epot = -18.3078407346463 | etot = -13.2825375234249 +571000 ekin = 2.99930468668979 | erot = 1.99774357915448 | epot = -18.2795857895248 | etot = -13.2825375236806 +572000 ekin = 2.98076231240025 | erot = 1.98107714031761 | epot = -18.2443769765725 | etot = -13.2825375238547 +573000 ekin = 2.95134611356941 | erot = 1.96535938854021 | epot = -18.1992430259928 | etot = -13.2825375238832 +574000 ekin = 2.91190615159568 | erot = 1.94906161388935 | epot = -18.1435052892122 | etot = -13.2825375237272 +575000 ekin = 2.86455063786228 | erot = 1.93223482555562 | epot = -18.0793229868005 | etot = -13.2825375233826 +576000 ekin = 2.81270724058511 | erot = 1.91646454101314 | epot = -18.0117093044836 | etot = -13.2825375228853 +577000 ekin = 2.76090536133269 | erot = 1.90450382048591 | epot = -17.9479467041287 | etot = -13.2825375223101 +578000 ekin = 2.71428886863997 | erot = 1.89991544414445 | epot = -17.8967418344493 | etot = -13.2825375216648 +579000 ekin = 2.67747364116322 | erot = 1.90598531717311 | epot = -17.8659964796474 | etot = -13.2825375213111 +580000 ekin = 2.65399321105106 | erot = 1.92422800253716 | epot = -17.8607587347071 | etot = -13.2825375211188 +581000 ekin = 2.64614770794032 | erot = 1.95489680825185 | epot = -17.8835820373323 | etot = -13.2825375211401 +582000 ekin = 2.65445309241879 | erot = 1.99685469221747 | epot = -17.9338453060313 | etot = -13.2825375213951 +583000 ekin = 2.67733631615637 | erot = 2.04763712314961 | epot = -18.0075109611623 | etot = -13.2825375218563 +584000 ekin = 2.71054840612045 | erot = 2.10372916962355 | epot = -18.096815098413 | etot = -13.282537522669 +585000 ekin = 2.7473776369314 | erot = 2.16073411837509 | epot = -18.1906492786902 | etot = -13.2825375233837 +586000 ekin = 2.78137869995175 | erot = 2.21419390101714 | epot = -18.2781101249393 | etot = -13.2825375239704 +587000 ekin = 2.80697388616102 | erot = 2.26053952383221 | epot = -18.3500509343302 | etot = -13.282537524337 +588000 ekin = 2.82026432882546 | erot = 2.29760845660692 | epot = -18.4004103098989 | etot = -13.2825375244665 +589000 ekin = 2.81926713949848 | erot = 2.32471340247678 | epot = -18.4265180663829 | etot = -13.2825375244076 +590000 ekin = 2.80363912226355 | erot = 2.34232144628702 | epot = -18.4284980927864 | etot = -13.2825375242358 +591000 ekin = 2.77414618261205 | erot = 2.35158565793045 | epot = -18.4082693645578 | etot = -13.2825375240153 +592000 ekin = 2.7321416208566 | erot = 2.3539767270547 | epot = -18.3686558716927 | etot = -13.2825375237814 +593000 ekin = 2.67919893320834 | erot = 2.35111989743036 | epot = -18.3128563541844 | etot = -13.2825375235457 +594000 ekin = 2.61691997595324 | erot = 2.34478637080631 | epot = -18.2442438700672 | etot = -13.2825375233077 +595000 ekin = 2.54687226720393 | erot = 2.33692048101831 | epot = -18.1663302712882 | etot = -13.282537523066 +596000 ekin = 2.47060065869688 | erot = 2.32961421032747 | epot = -18.0827523918473 | etot = -13.2825375228229 +597000 ekin = 2.38967001339545 | erot = 2.32500896596326 | epot = -17.9972165019425 | etot = -13.2825375225838 +598000 ekin = 2.30571268105541 | erot = 2.32515834060355 | epot = -17.913408544013 | etot = -13.2825375223541 +599000 ekin = 2.22046028573514 | erot = 2.33189649117281 | epot = -17.8348942990478 | etot = -13.2825375221398 +600000 ekin = 2.13574370513921 | erot = 2.34673734055139 | epot = -17.7650185676378 | etot = -13.2825375219472 +601000 ekin = 2.05345123960456 | erot = 2.37080533027377 | epot = -17.7067940916633 | etot = -13.282537521785 +602000 ekin = 1.97544542075628 | erot = 2.40478648027266 | epot = -17.6627694226918 | etot = -13.2825375216629 +603000 ekin = 1.90345105222632 | erot = 2.44889273151597 | epot = -17.6348813053331 | etot = -13.2825375215908 +604000 ekin = 1.83893895965995 | erot = 2.50284547564257 | epot = -17.6243219568744 | etot = -13.2825375215719 +605000 ekin = 1.78304137675034 | erot = 2.56590806862715 | epot = -17.6314869669817 | etot = -13.2825375216042 +606000 ekin = 1.73651700581096 | erot = 2.63697396076247 | epot = -17.6560284882492 | etot = -13.2825375216757 +607000 ekin = 1.69978182244358 | erot = 2.71471645477294 | epot = -17.6970357989852 | etot = -13.2825375217686 +608000 ekin = 1.67299629761026 | erot = 2.79777529949349 | epot = -17.7533091189676 | etot = -13.2825375218638 +609000 ekin = 1.65617951207475 | erot = 2.88492902620219 | epot = -17.8236460602245 | etot = -13.2825375219476 +610000 ekin = 1.64931072757095 | erot = 2.97519911997342 | epot = -17.9070473695603 | etot = -13.282537522016 +611000 ekin = 1.65238727041245 | erot = 3.06785620888426 | epot = -18.0027810013707 | etot = -13.282537522074 +612000 ekin = 1.66542824850629 | erot = 3.16233835683711 | epot = -18.1103041274766 | etot = -13.2825375221332 +613000 ekin = 1.68843555876185 | erot = 3.25812385015835 | epot = -18.229096931125 | etot = -13.2825375222048 +614000 ekin = 1.72133601897789 | erot = 3.35460405549752 | epot = -18.3584775967737 | etot = -13.2825375222983 +615000 ekin = 1.7639238606995 | erot = 3.45098117154084 | epot = -18.4974425546615 | etot = -13.2825375224212 +616000 ekin = 1.81580855367603 | erot = 3.54618284196742 | epot = -18.6445289182257 | etot = -13.2825375225823 +617000 ekin = 1.87635766459386 | erot = 3.63876572276478 | epot = -18.7976609101535 | etot = -13.2825375227949 +618000 ekin = 1.94461656677602 | erot = 3.72678561689433 | epot = -18.9539397067471 | etot = -13.2825375230768 +619000 ekin = 2.01919440960516 | erot = 3.80764382999315 | epot = -19.1093757630453 | etot = -13.282537523447 +620000 ekin = 2.09812821746402 | erot = 3.87796751070656 | epot = -19.2586332520846 | etot = -13.282537523914 +621000 ekin = 2.17876896466308 | erot = 3.93362434682925 | epot = -19.3949308359561 | etot = -13.2825375244638 +622000 ekin = 2.25776112958401 | erot = 3.96997899351304 | epot = -19.5102776481477 | etot = -13.2825375250507 +623000 ekin = 2.33118920334088 | erot = 3.98244070292824 | epot = -19.5961674318684 | etot = -13.2825375255993 +624000 ekin = 2.39492361725441 | erot = 3.96722578250777 | epot = -19.6446869257843 | etot = -13.2825375260221 +625000 ekin = 2.44512221108716 | erot = 3.9221202536408 | epot = -19.6497799909757 | etot = -13.2825375262478 +626000 ekin = 2.47876984854015 | erot = 3.84697362699248 | epot = -19.6082810017757 | etot = -13.282537526243 +627000 ekin = 2.49411681806274 | erot = 3.74375083232696 | epot = -19.5204051764073 | etot = -13.2825375260176 +628000 ekin = 2.49092177732992 | erot = 3.61617309028914 | epot = -19.3896323932286 | etot = -13.2825375256095 +629000 ekin = 2.47048208798929 | erot = 3.46915451618023 | epot = -19.2221741292344 | etot = -13.2825375250648 +630000 ekin = 2.43548970076025 | erot = 3.30827690339842 | epot = -19.0263041285834 | etot = -13.2825375244248 +631000 ekin = 2.38975949010187 | erot = 3.13944249310663 | epot = -18.8117395069329 | etot = -13.2825375237244 +632000 ekin = 2.33785618710456 | erot = 2.96869689900809 | epot = -18.5890906091134 | etot = -13.2825375230008 +633000 ekin = 2.28462964554081 | erot = 2.80211551079199 | epot = -18.3692826786328 | etot = -13.2825375223 +634000 ekin = 2.2346774623099 | erot = 2.64563252181923 | epot = -18.1628475058086 | etot = -13.2825375216794 +635000 ekin = 2.15322765553028 | erot = 2.4783509433522 | epot = -17.9141161496004 | etot = -13.2825375507179 +636000 ekin = 2.045499081381 | erot = 2.31412508402215 | epot = -17.6421616868316 | etot = -13.2825375214284 +637000 ekin = 2.11104805172142 | erot = 2.29419960724925 | epot = -17.6877852051452 | etot = -13.2825375461745 +638000 ekin = 2.16990019918255 | erot = 2.26795673930499 | epot = -17.720394476478 | etot = -13.2825375379904 +639000 ekin = 2.15825321743049 | erot = 2.17815663921299 | epot = -17.618947382429 | etot = -13.2825375257855 +640000 ekin = 2.18911467639275 | erot = 2.15600946820072 | epot = -17.627661668601 | etot = -13.2825375240076 +641000 ekin = 2.26653815117271 | erot = 2.22106973659358 | epot = -17.7701454239566 | etot = -13.2825375361904 +642000 ekin = 2.31444694707114 | erot = 2.28426426133692 | epot = -17.881248736019 | etot = -13.282537527611 +643000 ekin = 2.32966846048322 | erot = 2.3262511385741 | epot = -17.9384571271816 | etot = -13.2825375281243 +644000 ekin = 2.33971908597949 | erot = 2.36941556707019 | epot = -17.9916721815437 | etot = -13.2825375284941 +645000 ekin = 2.34497836829283 | erot = 2.40804261243074 | epot = -18.0355585093822 | etot = -13.2825375286587 +646000 ekin = 2.34716147904814 | erot = 2.43809135035135 | epot = -18.0677903580053 | etot = -13.2825375286058 +647000 ekin = 2.3490135196742 | erot = 2.45765540462488 | epot = -18.0892064526769 | etot = -13.2825375283778 +648000 ekin = 2.35429037946817 | erot = 2.46814608860667 | epot = -18.1049739961949 | etot = -13.28253752812 +649000 ekin = 2.36637490458858 | erot = 2.47306901786727 | epot = -18.1219814504981 | etot = -13.2825375280423 +650000 ekin = 2.38594651005796 | erot = 2.47280388226564 | epot = -18.1412879203047 | etot = -13.2825375279811 +651000 ekin = 2.4129073237406 | erot = 2.4679750054794 | epot = -18.163419857161 | etot = -13.282537527941 +652000 ekin = 2.44657292389676 | erot = 2.45942209560756 | epot = -18.1885325474125 | etot = -13.2825375279081 +653000 ekin = 2.48591189111066 | erot = 2.44818643115487 | epot = -18.2166358501265 | etot = -13.282537527861 +654000 ekin = 2.52980786333011 | erot = 2.43558904341108 | epot = -18.2479344345246 | etot = -13.2825375277834 +655000 ekin = 2.57725720727345 | erot = 2.42329690324718 | epot = -18.2830916381947 | etot = -13.2825375276741 +656000 ekin = 2.62745567851939 | erot = 2.41329334478414 | epot = -18.3232865508506 | etot = -13.2825375275471 +657000 ekin = 2.67977157718863 | erot = 2.40771681171411 | epot = -18.3700259163334 | etot = -13.2825375274306 +658000 ekin = 2.73363379212944 | erot = 2.40858022047282 | epot = -18.4247515399622 | etot = -13.2825375273599 +659000 ekin = 2.78837854445156 | erot = 2.41741767313059 | epot = -18.4883337449508 | etot = -13.2825375273687 +660000 ekin = 2.8431453631021 | erot = 2.43497153575953 | epot = -18.5606544262937 | etot = -13.282537527432 +661000 ekin = 2.89550751705154 | erot = 2.46002725134826 | epot = -18.6380722964866 | etot = -13.2825375280868 +662000 ekin = 2.93874528639294 | erot = 2.48685588449209 | epot = -18.708138699583 | etot = -13.282537528698 +663000 ekin = 2.96871719420213 | erot = 2.51022783061785 | epot = -18.7614825540622 | etot = -13.2825375292422 +664000 ekin = 2.98246138426592 | erot = 2.52516926728115 | epot = -18.7901681811315 | etot = -13.2825375295844 +665000 ekin = 2.97884445496409 | erot = 2.52787955702933 | epot = -18.7892615416111 | etot = -13.2825375296177 +666000 ekin = 2.95920183358837 | erot = 2.5166150843606 | epot = -18.7583544472577 | etot = -13.2825375293087 +667000 ekin = 2.92742550364064 | erot = 2.49210329863614 | epot = -18.7020663309941 | etot = -13.2825375287173 +668000 ekin = 2.88934250727334 | erot = 2.45736670758744 | epot = -18.6292467428357 | etot = -13.2825375279749 +669000 ekin = 2.85155010055246 | erot = 2.41708074188009 | epot = -18.5511683696627 | etot = -13.2825375272301 +670000 ekin = 2.82014314483841 | erot = 2.37673699564913 | epot = -18.4794176670842 | etot = -13.2825375265966 +671000 ekin = 2.79977472973266 | erot = 2.34183940288387 | epot = -18.4241516588856 | etot = -13.2825375262691 +672000 ekin = 2.7929325264564 | erot = 2.3169522602719 | epot = -18.3924223127253 | etot = -13.282537525997 +673000 ekin = 2.80034442418812 | erot = 2.30554472221923 | epot = -18.3884266723436 | etot = -13.2825375259362 +674000 ekin = 2.82129825266147 | erot = 2.30955451996833 | epot = -18.4133902987243 | etot = -13.2825375260945 +675000 ekin = 2.85361934154458 | erot = 2.32878748983352 | epot = -18.4649443578395 | etot = -13.2825375264614 +676000 ekin = 2.89394925003076 | erot = 2.36084337721496 | epot = -18.5373301542345 | etot = -13.2825375269888 +677000 ekin = 2.93819888444081 | erot = 2.40146056818827 | epot = -18.6221969802158 | etot = -13.2825375275867 +678000 ekin = 2.98219881053812 | erot = 2.44527797803552 | epot = -18.7100143167158 | etot = -13.2825375281422 +679000 ekin = 3.02242735526952 | erot = 2.48684948039664 | epot = -18.7918143642177 | etot = -13.2825375285515 +680000 ekin = 3.05660821688331 | erot = 2.52163649392475 | epot = -18.860782239561 | etot = -13.282537528753 +681000 ekin = 3.08399348193173 | erot = 2.54671087872184 | epot = -18.913241889389 | etot = -13.2825375287354 +682000 ekin = 3.10527370313695 | erot = 2.56103519422108 | epot = -18.9488464258989 | etot = -13.2825375285409 +683000 ekin = 3.12217420792303 | erot = 2.5653012869435 | epot = -18.9700130231063 | etot = -13.2825375282397 +684000 ekin = 3.13689854385765 | erot = 2.56147023269689 | epot = -18.9809063044635 | etot = -13.282537527909 +685000 ekin = 3.15161752084921 | erot = 2.55220833209368 | epot = -18.9863633805374 | etot = -13.2825375275945 +686000 ekin = 3.16825656296352 | erot = 2.54047141966045 | epot = -18.9912655100342 | etot = -13.2825375274102 +687000 ekin = 3.18756268905896 | erot = 2.5286150857463 | epot = -18.9987153021306 | etot = -13.2825375273253 +688000 ekin = 3.20935294731744 | erot = 2.51834078650268 | epot = -19.010231261173 | etot = -13.2825375273529 +689000 ekin = 3.23260385768977 | erot = 2.51058529366538 | epot = -19.0257266788501 | etot = -13.2825375274949 +690000 ekin = 3.25550449418191 | erot = 2.50541094761942 | epot = -19.0434529695448 | etot = -13.2825375277435 +691000 ekin = 3.27559454465419 | erot = 2.50196131508042 | epot = -19.0600933878108 | etot = -13.2825375280762 +692000 ekin = 3.29000453531072 | erot = 2.49851988080605 | epot = -19.0710619445671 | etot = -13.2825375284504 +693000 ekin = 3.29579865375948 | erot = 2.4927397485969 | epot = -19.0710759311631 | etot = -13.2825375288067 +694000 ekin = 3.290367420064 | erot = 2.48207188558618 | epot = -19.0549768347317 | etot = -13.2825375290815 +695000 ekin = 3.27176421099226 | erot = 2.46431581834491 | epot = -19.0186175585658 | etot = -13.2825375292286 +696000 ekin = 3.23887890264527 | erot = 2.43812365839389 | epot = -18.9595400902738 | etot = -13.2825375292346 +697000 ekin = 3.19141377365438 | erot = 2.40329594557291 | epot = -18.8772472483422 | etot = -13.2825375291149 +698000 ekin = 3.12971664160265 | erot = 2.3607993405226 | epot = -18.7730535110309 | etot = -13.2825375289056 +699000 ekin = 3.05458980607575 | erot = 2.31258576051436 | epot = -18.6497130952223 | etot = -13.2825375286322 +700000 ekin = 2.96718102277338 | erot = 2.26139197222678 | epot = -18.5111105233092 | etot = -13.282537528309 +701000 ekin = 2.86896613270987 | erot = 2.21057215475942 | epot = -18.3620758154114 | etot = -13.2825375279421 +702000 ekin = 2.76178671310755 | erot = 2.16397434370647 | epot = -18.2082985843512 | etot = -13.2825375275372 +703000 ekin = 2.64787120281757 | erot = 2.12574771765488 | epot = -18.0561564514672 | etot = -13.2825375309947 +704000 ekin = 2.52933762816201 | erot = 2.08674637167894 | epot = -17.8986215285157 | etot = -13.2825375286748 +705000 ekin = 2.41679696488455 | erot = 2.0566401236899 | epot = -17.7559746148443 | etot = -13.2825375262699 +706000 ekin = 2.30501007301267 | erot = 2.06115876579317 | epot = -17.6487063632602 | etot = -13.2825375244543 +707000 ekin = 2.19269241312063 | erot = 2.11375046401179 | epot = -17.5889804017709 | etot = -13.2825375246385 +708000 ekin = 2.09960598295589 | erot = 2.19681319913428 | epot = -17.5789567090833 | etot = -13.2825375269932 +709000 ekin = 2.01320280572636 | erot = 2.28016876669421 | epot = -17.5759090978068 | etot = -13.2825375253862 +710000 ekin = 1.93302644378252 | erot = 2.3747322880584 | epot = -17.5902962577935 | etot = -13.2825375259526 +711000 ekin = 1.85957279021245 | erot = 2.47358324949964 | epot = -17.6156935663468 | etot = -13.2825375266347 +712000 ekin = 1.79282630225992 | erot = 2.56690430163368 | epot = -17.6422681311821 | etot = -13.2825375272885 +713000 ekin = 1.73341814837551 | erot = 2.64462400363359 | epot = -17.660579679756 | etot = -13.2825375277469 +714000 ekin = 1.68328438218602 | erot = 2.6981736471422 | epot = -17.6639955572078 | etot = -13.2825375278795 +715000 ekin = 1.64594117620278 | erot = 2.72207244137003 | epot = -17.6505511452259 | etot = -13.2825375276531 +716000 ekin = 1.62610172677928 | erot = 2.71479815184846 | epot = -17.6234374057783 | etot = -13.2825375271506 +717000 ekin = 1.62864489608611 | erot = 2.67867233654835 | epot = -17.5898547591674 | etot = -13.2825375265329 +718000 ekin = 1.65730138294327 | erot = 2.6189183930066 | epot = -17.5587573019149 | etot = -13.282537525965 +719000 ekin = 1.71360335043978 | erot = 2.54235654261391 | epot = -17.5384974186061 | etot = -13.2825375255524 +720000 ekin = 1.79650653895858 | erot = 2.45621436721656 | epot = -17.5352584314959 | etot = -13.2825375253208 +721000 ekin = 1.90273489837533 | erot = 2.36731439674759 | epot = -17.5525868203611 | etot = -13.2825375252382 +722000 ekin = 2.02756635859999 | erot = 2.28163864623686 | epot = -17.5917425300939 | etot = -13.2825375252571 +723000 ekin = 2.16566245404416 | erot = 2.20411346317412 | epot = -17.6523134425647 | etot = -13.2825375253464 +724000 ekin = 2.31164907954197 | erot = 2.13844446421075 | epot = -17.7326310692571 | etot = -13.2825375255043 +725000 ekin = 2.46036017261476 | erot = 2.0869120442021 | epot = -17.8298097425667 | etot = -13.2825375257498 +726000 ekin = 2.6068349632846 | erot = 2.05013619410202 | epot = -17.9395086834918 | etot = -13.2825375261052 +727000 ekin = 2.74622028370769 | erot = 2.02690424048558 | epot = -18.0556620507673 | etot = -13.2825375265741 +728000 ekin = 2.87374866232265 | erot = 2.01419303060157 | epot = -18.1704792200511 | etot = -13.2825375271269 +729000 ekin = 2.98490085153144 | erot = 2.00751009684072 | epot = -18.2749484760646 | etot = -13.2825375276924 +730000 ekin = 3.07576690645469 | erot = 2.00160558057494 | epot = -18.3599100152017 | etot = -13.2825375281721 +731000 ekin = 3.14351022556136 | erot = 1.99146923005515 | epot = -18.4175169840844 | etot = -13.2825375284679 +732000 ekin = 3.18676307270908 | erot = 1.9733775068131 | epot = -18.4426781080378 | etot = -13.2825375285156 +733000 ekin = 3.20579220143817 | erot = 1.94568706577985 | epot = -18.4340167955229 | etot = -13.2825375283049 +734000 ekin = 3.20238921808403 | erot = 1.9091725140226 | epot = -18.3940992599778 | etot = -13.2825375278711 +735000 ekin = 3.17951096478395 | erot = 1.86680153214189 | epot = -18.3288500242332 | etot = -13.2825375273073 +736000 ekin = 3.1407386539016 | erot = 1.82300587571906 | epot = -18.2462820563141 | etot = -13.2825375266935 +737000 ekin = 3.08984658439833 | erot = 1.78292392999538 | epot = -18.1553080405002 | etot = -13.2825375261065 +738000 ekin = 3.03043228105068 | erot = 1.7516193492114 | epot = -18.0645891558627 | etot = -13.2825375256006 +739000 ekin = 2.96566842761532 | erot = 1.73346651074128 | epot = -17.9816724635652 | etot = -13.2825375252086 +740000 ekin = 2.89817088990248 | erot = 1.73175552827542 | epot = -17.9124639431193 | etot = -13.2825375249414 +741000 ekin = 2.82995232215527 | erot = 1.74850528578322 | epot = -17.8609951327411 | etot = -13.2825375248026 +742000 ekin = 2.76247533975977 | erot = 1.78434362324901 | epot = -17.8293564878077 | etot = -13.2825375247989 +743000 ekin = 2.69668176522496 | erot = 1.83847103615502 | epot = -17.8176903262763 | etot = -13.2825375248963 +744000 ekin = 2.63311444617166 | erot = 1.90875045497562 | epot = -17.8244024262527 | etot = -13.2825375251054 +745000 ekin = 2.57196493518836 | erot = 1.99171779916653 | epot = -17.8462202597747 | etot = -13.2825375254198 +746000 ekin = 2.5131159615418 | erot = 2.08264215541026 | epot = -17.8782956427778 | etot = -13.2825375258257 +747000 ekin = 2.4562102402775 | erot = 2.17571767167211 | epot = -17.9144654382424 | etot = -13.2825375262928 +748000 ekin = 2.4007641204688 | erot = 2.2644524277425 | epot = -17.9477540749797 | etot = -13.2825375267684 +749000 ekin = 2.34635697391007 | erot = 2.34231237519854 | epot = -17.9712068762851 | etot = -13.2825375271765 +750000 ekin = 2.29290375451717 | erot = 2.40359513791455 | epot = -17.979036419863 | etot = -13.2825375274312 +751000 ekin = 2.24097207238015 | erot = 2.44437862762129 | epot = -17.9678882274625 | etot = -13.2825375274611 +752000 ekin = 2.19206377657606 | erot = 2.46328788077229 | epot = -17.937889184575 | etot = -13.2825375272267 +753000 ekin = 2.0191073671841 | erot = 2.37844688220293 | epot = -17.6800917192494 | etot = -13.2825374698623 +754000 ekin = 2.03397419691681 | erot = 2.38379927449377 | epot = -17.7003109683856 | etot = -13.282537496975 +755000 ekin = 2.10287082567493 | erot = 2.42269050483285 | epot = -17.8080987746467 | etot = -13.2825374441389 +756000 ekin = 2.09556625439565 | erot = 2.405750962181 | epot = -17.7838546600866 | etot = -13.2825374435099 +757000 ekin = 2.11013463581362 | erot = 2.39174642164209 | epot = -17.7844185004694 | etot = -13.2825374430137 +758000 ekin = 2.14991880579705 | erot = 2.38537981437436 | epot = -17.8178360628955 | etot = -13.2825374427241 +759000 ekin = 2.21691275063063 | erot = 2.38948785825167 | epot = -17.8889380515667 | etot = -13.2825374426844 +760000 ekin = 2.31141054860375 | erot = 2.40468264900161 | epot = -17.9986306405271 | etot = -13.2825374429218 +761000 ekin = 2.4317547235321 | erot = 2.42917556854271 | epot = -18.14346773552 | etot = -13.2825374434452 +762000 ekin = 2.57423243233675 | erot = 2.45878794777349 | epot = -18.3155578243444 | etot = -13.2825374442342 +763000 ekin = 2.73317609318437 | erot = 2.48721280711223 | epot = -18.5029263455259 | etot = -13.2825374452293 +764000 ekin = 2.90131643265847 | erot = 2.50663479921391 | epot = -18.6904886781953 | etot = -13.2825374463229 +765000 ekin = 3.07040159501002 | erot = 2.50879317398454 | epot = -18.8617322163581 | etot = -13.2825374473636 +766000 ekin = 3.23203070978082 | erot = 2.48644536574614 | epot = -19.0010135237083 | etot = -13.2825374481813 +767000 ekin = 3.37856609433327 | erot = 2.43498274045147 | epot = -19.096086283418 | etot = -13.2825374486333 +768000 ekin = 3.50392633253189 | erot = 2.35374465438907 | epot = -19.14020843557 | etot = -13.282537448649 +769000 ekin = 3.60408079934929 | erot = 2.2465665844398 | epot = -19.1331848320412 | etot = -13.2825374482521 +770000 ekin = 3.67731902040089 | erot = 2.12129310034524 | epot = -19.0811495682864 | etot = -13.2825374475402 +771000 ekin = 3.7250046645363 | erot = 1.98803923032005 | epot = -18.9955813415612 | etot = -13.2825374467049 +772000 ekin = 3.73784328843035 | erot = 1.84847100678562 | epot = -18.8688517433746 | etot = -13.2825374481586 +773000 ekin = 3.73518377757204 | erot = 1.74399251359463 | epot = -18.7617137365844 | etot = -13.2825374454177 +774000 ekin = 3.73326270308357 | erot = 1.69319142531066 | epot = -18.7089915825401 | etot = -13.2825374541459 +775000 ekin = 3.70600760956875 | erot = 1.65662399761182 | epot = -18.6451690552018 | etot = -13.2825374480212 +776000 ekin = 3.66620955944038 | erot = 1.65229490513874 | epot = -18.6010419124108 | etot = -13.2825374478317 +777000 ekin = 3.6164959066655 | erot = 1.68124406400525 | epot = -18.5802774185067 | etot = -13.2825374478359 +778000 ekin = 3.5589217195722 | erot = 1.74156460645431 | epot = -18.5830237740648 | etot = -13.2825374480383 +779000 ekin = 3.49505249793887 | erot = 1.82861083484593 | epot = -18.6062007816394 | etot = -13.2825374488546 +780000 ekin = 3.4260605289351 | erot = 1.93200454544541 | epot = -18.6406025240164 | etot = -13.2825374496359 +781000 ekin = 3.35141348649702 | erot = 2.04005284529073 | epot = -18.6740037822594 | etot = -13.2825374504716 +782000 ekin = 3.27002343600189 | erot = 2.14152553689654 | epot = -18.6940864240875 | etot = -13.2825374511891 +783000 ekin = 3.18141085606315 | erot = 2.22636120778713 | epot = -18.6903095154617 | etot = -13.2825374516114 +784000 ekin = 3.08656488448361 | erot = 2.28735807323151 | epot = -18.6564604093344 | etot = -13.2825374516193 +785000 ekin = 2.98843913984933 | erot = 2.32136711553602 | epot = -18.592343706592 | etot = -13.2825374512067 +786000 ekin = 2.89178850735618 | erot = 2.32954149828313 | epot = -18.5038674561269 | etot = -13.2825374504876 +787000 ekin = 2.80233070714568 | erot = 2.31656731743012 | epot = -18.4014354742217 | etot = -13.2825374496459 +788000 ekin = 2.72556137455006 | erot = 2.28924565768276 | epot = -18.2973444810906 | etot = -13.2825374488578 +789000 ekin = 2.66569850120894 | erot = 2.25498711353627 | epot = -18.2032230629877 | etot = -13.2825374482425 +790000 ekin = 2.62507547495403 | erot = 2.22062577794997 | epot = -18.1282387007584 | etot = -13.2825374478544 +791000 ekin = 2.60400664845757 | erot = 2.19166523695208 | epot = -18.0782093331145 | etot = -13.2825374477048 +792000 ekin = 2.60095165826993 | erot = 2.17186849883267 | epot = -18.0553576048892 | etot = -13.2825374477866 +793000 ekin = 2.61278727136947 | erot = 2.1630579475058 | epot = -18.0583826669628 | etot = -13.2825374480875 +794000 ekin = 2.63509078750899 | erot = 2.16503786010594 | epot = -18.0826660962031 | etot = -13.2825374485882 +795000 ekin = 2.66245645496094 | erot = 2.17562900151097 | epot = -18.1206229057215 | etot = -13.2825374492496 +796000 ekin = 2.68895951797515 | erot = 2.19088748039119 | epot = -18.1623844483558 | etot = -13.2825374499895 +797000 ekin = 2.70892452636473 | erot = 2.20564060882902 | epot = -18.197102585859 | etot = -13.2825374506652 +798000 ekin = 2.7187387406754 | erot = 2.21455364300775 | epot = -18.2158298332747 | etot = -13.2825374495916 +799000 ekin = 2.70000300099405 | erot = 2.21050545408876 | epot = -18.193045904985 | etot = -13.2825374499022 +800000 ekin = 2.65392049001821 | erot = 2.17300546938151 | epot = -18.109463378289 | etot = -13.2825374188892 +801000 ekin = 2.82505345096871 | erot = 2.13616134701489 | epot = -18.2437522525054 | etot = -13.2825374545218 +802000 ekin = 2.90470228802172 | erot = 2.10953657449614 | epot = -18.2967762799053 | etot = -13.2825374173874 +803000 ekin = 2.9677525986453 | erot = 2.08137573444383 | epot = -18.3316657512964 | etot = -13.2825374182072 +804000 ekin = 3.01419864036155 | erot = 2.05336319939514 | epot = -18.3500992581057 | etot = -13.282537418349 +805000 ekin = 3.03950260682403 | erot = 2.02738087474037 | epot = -18.3494208999164 | etot = -13.282537418352 +806000 ekin = 3.04147612212525 | erot = 2.00524180108709 | epot = -18.3292553414124 | etot = -13.2825374182001 +807000 ekin = 3.02009152418646 | erot = 1.98876425940777 | epot = -18.2913932015099 | etot = -13.2825374179157 +808000 ekin = 2.97716861905469 | erot = 1.9797928070483 | epot = -18.2394988436566 | etot = -13.2825374175536 +809000 ekin = 2.91576405317411 | erot = 1.98007542202132 | epot = -18.1783768923745 | etot = -13.282537417179 +810000 ekin = 2.83951999241211 | erot = 1.9910201414007 | epot = -18.1130775506578 | etot = -13.282537416845 +811000 ekin = 2.75216924413256 | erot = 2.01344070631007 | epot = -18.0481473670229 | etot = -13.2825374165802 +812000 ekin = 2.65727213949033 | erot = 2.04739495870437 | epot = -17.9872045145838 | etot = -13.2825374163891 +813000 ekin = 2.55815480063288 | erot = 2.0921579466292 | epot = -17.9328501635216 | etot = -13.2825374162596 +814000 ekin = 2.45796623947603 | erot = 2.14630993528002 | epot = -17.8868135909302 | etot = -13.2825374161741 +815000 ekin = 2.35976627429823 | erot = 2.20788718833984 | epot = -17.8501908787554 | etot = -13.2825374161174 +816000 ekin = 2.26657575180629 | erot = 2.27454135561794 | epot = -17.8236545235058 | etot = -13.2825374160815 +817000 ekin = 2.18134946662811 | erot = 2.34367133400565 | epot = -17.807558216702 | etot = -13.2825374160682 +818000 ekin = 2.10686415591836 | erot = 2.41251844102779 | epot = -17.8019200130316 | etot = -13.2825374160855 +819000 ekin = 2.04554497258418 | erot = 2.47824070162555 | epot = -17.806323090351 | etot = -13.2825374161413 +820000 ekin = 1.99927680295696 | erot = 2.53799486378974 | epot = -17.8198090829855 | etot = -13.2825374162388 +821000 ekin = 1.9692530805303 | erot = 2.58905270210877 | epot = -17.8408431990125 | etot = -13.2825374163734 +822000 ekin = 1.95590272174924 | erot = 2.62895986938386 | epot = -17.8674000076635 | etot = -13.2825374165304 +823000 ekin = 1.95890926788755 | erot = 2.6557286058008 | epot = -17.8971752903778 | etot = -13.2825374166894 +824000 ekin = 1.97731046162633 | erot = 2.66804286128345 | epot = -17.9278907397372 | etot = -13.2825374168275 +825000 ekin = 2.00964945342457 | erot = 2.66544750451175 | epot = -17.9576343748594 | etot = -13.2825374169231 +826000 ekin = 2.05414423139186 | erot = 2.64849047550104 | epot = -17.985172123854 | etot = -13.2825374169611 +827000 ekin = 2.10884212199665 | erot = 2.61877894485958 | epot = -18.0101584837945 | etot = -13.2825374169382 +828000 ekin = 2.1717293569375 | erot = 2.57890618314315 | epot = -18.0331729569469 | etot = -13.2825374168662 +829000 ekin = 2.24077304847179 | erot = 2.53221651091816 | epot = -18.0555269761626 | etot = -13.2825374167726 +830000 ekin = 2.31389012743404 | erot = 2.4824115756111 | epot = -18.0788391197418 | etot = -13.2825374166967 +831000 ekin = 2.38886546542343 | erot = 2.43305573494131 | epot = -18.1044586170416 | etot = -13.2825374166768 +832000 ekin = 2.4632691578231 | erot = 2.3870870487244 | epot = -18.1328936232866 | etot = -13.2825374167391 +833000 ekin = 2.5344365632194 | erot = 2.34645691813147 | epot = -18.1634308982373 | etot = -13.2825374168864 +834000 ekin = 2.59956439019907 | erot = 2.31199374777391 | epot = -18.1940955550686 | etot = -13.2825374170956 +835000 ekin = 2.65594315943653 | erot = 2.28352232821168 | epot = -18.2220029049695 | etot = -13.2825374173213 +836000 ekin = 2.70130042683167 | erot = 2.26019210697788 | epot = -18.244029951319 | etot = -13.2825374175095 +837000 ekin = 2.73418787962871 | erot = 2.24090836893314 | epot = -18.2576336661722 | etot = -13.2825374176104 +838000 ekin = 2.75431729342696 | erot = 2.22474076288568 | epot = -18.2615954739057 | etot = -13.2825374175931 +839000 ekin = 2.76274241629131 | erot = 2.21121141093012 | epot = -18.256491244675 | etot = -13.2825374174536 +840000 ekin = 2.76179432989972 | erot = 2.20041723303662 | epot = -18.2447489801545 | etot = -13.2825374172182 +841000 ekin = 2.75470877518085 | erot = 2.19297958495076 | epot = -18.2302257770756 | etot = -13.2825374169439 +842000 ekin = 2.74495192528053 | erot = 2.18982916449433 | epot = -18.2173185064846 | etot = -13.2825374167098 +843000 ekin = 2.73536701846579 | erot = 2.19185320024881 | epot = -18.2097576353086 | etot = -13.282537416594 +844000 ekin = 2.72739699349177 | erot = 2.1994851694244 | epot = -18.2094195795621 | etot = -13.2825374166459 +845000 ekin = 2.7206968024524 | erot = 2.21238342751528 | epot = -18.2156176468218 | etot = -13.2825374168541 +846000 ekin = 2.71335246036253 | erot = 2.22935500856137 | epot = -18.2252448860709 | etot = -13.282537417147 +847000 ekin = 2.70267547916117 | erot = 2.24859000373239 | epot = -18.2338029003123 | etot = -13.2825374174188 +848000 ekin = 2.68627675195779 | erot = 2.26812231144288 | epot = -18.236936480973 | etot = -13.2825374175723 +849000 ekin = 2.66300406671244 | erot = 2.2863229263121 | epot = -18.2318644105805 | etot = -13.282537417556 +850000 ekin = 2.63341305523148 | erot = 2.30223029747857 | epot = -18.2181807700874 | etot = -13.2825374173774 +851000 ekin = 2.59966043365591 | erot = 2.3156167587262 | epot = -18.1978146094748 | etot = -13.2825374170927 +852000 ekin = 2.56493307993571 | erot = 2.32681510713484 | epot = -18.1742856038479 | etot = -13.2825374167774 +853000 ekin = 2.53268459155754 | erot = 2.33642702138572 | epot = -18.1516490294471 | etot = -13.2825374165038 +854000 ekin = 2.50591352797944 | erot = 2.34503055123976 | epot = -18.1334814955374 | etot = -13.2825374163182 +855000 ekin = 2.4866740476675 | erot = 2.35297873120409 | epot = -18.1221901951049 | etot = -13.2825374162333 +856000 ekin = 2.47592780860343 | erot = 2.36034202539965 | epot = -18.1188072502362 | etot = -13.2825374162331 +857000 ekin = 2.47367803510516 | erot = 2.36697109794411 | epot = -18.1231865493438 | etot = -13.2825374162946 +858000 ekin = 2.47922391681366 | erot = 2.37260088210265 | epot = -18.1343622152926 | etot = -13.2825374163763 +859000 ekin = 2.49150776870147 | erot = 2.37701215984104 | epot = -18.1510573449986 | etot = -13.282537416456 +860000 ekin = 2.50937686784747 | erot = 2.38013993594023 | epot = -18.1720542203101 | etot = -13.2825374165224 +861000 ekin = 2.53170635996116 | erot = 2.38211817150425 | epot = -18.1963619480387 | etot = -13.2825374165732 +862000 ekin = 2.55742566626407 | erot = 2.38328933264109 | epot = -18.2232524155165 | etot = -13.2825374166114 +863000 ekin = 2.58549483187838 | erot = 2.38419488482973 | epot = -18.252227133347 | etot = -13.2825374166389 +864000 ekin = 2.61488041066499 | erot = 2.38555368834993 | epot = -18.2829715156728 | etot = -13.2825374166579 +865000 ekin = 2.64455846347095 | erot = 2.38821849192421 | epot = -18.3153143720654 | etot = -13.2825374166702 +866000 ekin = 2.67354800424437 | erot = 2.39309523344314 | epot = -18.3491806543665 | etot = -13.282537416679 +867000 ekin = 2.70096216988177 | erot = 2.40101926554071 | epot = -18.3845188521138 | etot = -13.2825374166913 +868000 ekin = 2.72584498338572 | erot = 2.41260829074957 | epot = -18.420990690944 | etot = -13.2825374168087 +869000 ekin = 2.74685098606623 | erot = 2.42808376653873 | epot = -18.4574721694777 | etot = -13.2825374168728 +870000 ekin = 2.76334516398283 | erot = 2.44707202879413 | epot = -18.4929546097441 | etot = -13.2825374169672 +871000 ekin = 2.77488977710316 | erot = 2.46856883163597 | epot = -18.5259960258323 | etot = -13.2825374170932 +872000 ekin = 2.7811573123189 | erot = 2.49101078851438 | epot = -18.5547055180778 | etot = -13.2825374172445 +873000 ekin = 2.78190152502928 | erot = 2.51241399879738 | epot = -18.5768529412309 | etot = -13.2825374174043 +874000 ekin = 2.77696693725528 | erot = 2.53063897161364 | epot = -18.5901433264131 | etot = -13.2825374175441 +875000 ekin = 2.76636320213146 | erot = 2.54374754436265 | epot = -18.5926481641224 | etot = -13.2825374176283 +876000 ekin = 2.7504069828229 | erot = 2.55039472310231 | epot = -18.5833391235459 | etot = -13.2825374176207 +877000 ekin = 2.72989722810813 | erot = 2.55017286557422 | epot = -18.5626075111784 | etot = -13.2825374174961 +878000 ekin = 2.70625700294355 | erot = 2.54382115071376 | epot = -18.5326155709077 | etot = -13.2825374172503 +879000 ekin = 2.68156506653427 | erot = 2.5332421351554 | epot = -18.4973446185932 | etot = -13.2825374169036 +880000 ekin = 2.65843100554442 | erot = 2.52132216836891 | epot = -18.4622905904093 | etot = -13.282537416496 +881000 ekin = 2.63972432922979 | erot = 2.51160592366972 | epot = -18.4338676689779 | etot = -13.2825374160784 +882000 ekin = 2.62822235403347 | erot = 2.50790034454678 | epot = -18.4186601142802 | etot = -13.2825374157 +883000 ekin = 2.62626662137136 | erot = 2.51387422299541 | epot = -18.4226782597687 | etot = -13.2825374154019 +884000 ekin = 2.63550251772652 | erot = 2.53269090787765 | epot = -18.4507308408175 | etot = -13.2825374152133 +885000 ekin = 2.65673814855014 | erot = 2.56668643457077 | epot = -18.5059619982733 | etot = -13.2825374151524 +886000 ekin = 2.68991717237218 | erot = 2.61709354768266 | epot = -18.5895481352837 | etot = -13.2825374152289 +887000 ekin = 2.734175532827 | erot = 2.68381522130244 | epot = -18.700528169575 | etot = -13.2825374154455 +888000 ekin = 2.78795008719356 | erot = 2.76526591136903 | epot = -18.8357534143588 | etot = -13.2825374157962 +889000 ekin = 2.8491201813508 | erot = 2.85831710930318 | epot = -18.989974706918 | etot = -13.282537416264 +890000 ekin = 2.91517691868807 | erot = 2.95839462643955 | epot = -19.1561089619448 | etot = -13.2825374168172 +891000 ekin = 2.98341767192295 | erot = 3.0597676506775 | epot = -19.3257227400102 | etot = -13.2825374174098 +892000 ekin = 3.05115351644501 | erot = 3.15603968258129 | epot = -19.4897306170114 | etot = -13.2825374179851 +893000 ekin = 3.11590367361418 | erot = 3.24080526805507 | epot = -19.6392463601538 | etot = -13.2825374184846 +894000 ekin = 3.17554453075818 | erot = 3.30838805788589 | epot = -19.7664700075009 | etot = -13.2825374188568 +895000 ekin = 3.22839008561766 | erot = 3.35454380060236 | epot = -19.8654713052867 | etot = -13.2825374190666 +896000 ekin = 3.27319975165836 | erot = 3.37700709394957 | epot = -19.9327442647079 | etot = -13.2825374191 +897000 ekin = 3.30912548499472 | erot = 3.37578332995761 | epot = -19.9674462339186 | etot = -13.2825374189663 +898000 ekin = 3.33561719415195 | erot = 3.35313099566656 | epot = -19.9712856085154 | etot = -13.2825374186968 +899000 ekin = 3.3523031028265 | erot = 3.31323476596136 | epot = -19.9480752871285 | etot = -13.2825374183407 +900000 ekin = 3.35886034531518 | erot = 3.26162723064569 | epot = -19.9030249939161 | etot = -13.2825374179552 +901000 ekin = 3.35489762759567 | erot = 3.2044644832284 | epot = -19.8418995284194 | etot = -13.2825374175953 +902000 ekin = 3.33988398839342 | erot = 3.14778460407791 | epot = -19.7702060097741 | etot = -13.2825374173028 +903000 ekin = 3.31316641909532 | erot = 3.09687096103035 | epot = -19.6925747972223 | etot = -13.2825374170966 +904000 ekin = 3.27411465419852 | erot = 3.05580881217869 | epot = -19.6124608833472 | etot = -13.2825374169699 +905000 ekin = 3.22240761869358 | erot = 3.02727711490202 | epot = -19.5322221504879 | etot = -13.2825374168923 +906000 ekin = 3.15843123363071 | erot = 3.01257047164431 | epot = -19.4535391220934 | etot = -13.2825374168184 +907000 ekin = 3.08369713046712 | erot = 3.01180553644323 | epot = -19.3780400836148 | etot = -13.2825374167044 +908000 ekin = 3.00113487352882 | erot = 3.02423547646297 | epot = -19.3079077665171 | etot = -13.2825374165253 +909000 ekin = 2.91509126964 | erot = 3.04858097597399 | epot = -19.246209661904 | etot = -13.28253741629 +910000 ekin = 2.83091809249006 | erot = 3.08328866196603 | epot = -19.1967441705011 | etot = -13.282537416045 +911000 ekin = 2.75416042802549 | erot = 3.12665661766781 | epot = -19.1633544615573 | etot = -13.282537415864 +912000 ekin = 2.68982240197673 | erot = 3.17670303509253 | epot = -19.1490628528293 | etot = -13.2825374157601 +913000 ekin = 2.64026279480142 | erot = 3.23106967171228 | epot = -19.1538698824696 | etot = -13.2825374159559 +914000 ekin = 2.60494541586834 | erot = 3.28757760350067 | epot = -19.1750604355173 | etot = -13.2825374161483 +915000 ekin = 2.58331294380949 | erot = 3.34356245576663 | epot = -19.2094128163232 | etot = -13.282537416747 +916000 ekin = 2.572225278094 | erot = 3.39542630003117 | epot = -19.250188995406 | etot = -13.2825374172809 +917000 ekin = 2.56717380000648 | erot = 3.43991413165374 | epot = -19.2896253494389 | etot = -13.2825374177786 +918000 ekin = 2.56366862414259 | erot = 3.47431911369141 | epot = -19.3205251559853 | etot = -13.2825374181513 +919000 ekin = 2.55808580528835 | erot = 3.4968825160616 | epot = -19.337505739687 | etot = -13.2825374183371 +920000 ekin = 2.54828083604877 | erot = 3.50706786620944 | epot = -19.3378861205732 | etot = -13.2825374183149 +921000 ekin = 2.5338583783986 | erot = 3.5055796155901 | epot = -19.3219754120972 | etot = -13.2825374181085 +922000 ekin = 2.516060534879 | erot = 3.49409623125511 | epot = -19.2926941839177 | etot = -13.2825374177836 +923000 ekin = 2.49728909023619 | erot = 3.47476611514256 | epot = -19.2545926228132 | etot = -13.2825374174344 +924000 ekin = 2.48035717414061 | erot = 3.44958564359935 | epot = -19.2124802348989 | etot = -13.282537417159 +925000 ekin = 2.46765713433988 | erot = 3.41982437245358 | epot = -19.1700189238237 | etot = -13.2825374170303 +926000 ekin = 2.46048446299621 | erot = 3.38566546870185 | epot = -19.1286873487718 | etot = -13.2825374170737 +927000 ekin = 2.45872404418899 | erot = 3.34617863044022 | epot = -19.0874400918875 | etot = -13.2825374172583 +928000 ekin = 2.46097855235184 | erot = 3.29964380866974 | epot = -19.043159778532 | etot = -13.2825374175104 +929000 ekin = 2.46505358100394 | erot = 3.24413140303551 | epot = -18.99172240178 | etot = -13.2825374177406 +930000 ekin = 2.46859437790869 | erot = 3.17816487222183 | epot = -18.9292966680023 | etot = -13.2825374178718 +931000 ekin = 2.46965047248253 | erot = 3.10127887163483 | epot = -18.8534667619775 | etot = -13.2825374178601 +932000 ekin = 2.46701732520898 | erot = 3.01434779059203 | epot = -18.7639025334928 | etot = -13.2825374176918 +933000 ekin = 2.46031519086868 | erot = 2.91973998893973 | epot = -18.662592597222 | etot = -13.2825374174136 +934000 ekin = 2.44985996507097 | erot = 2.82081794907183 | epot = -18.5532153312021 | etot = -13.2825374170593 +935000 ekin = 2.43642057973712 | erot = 2.72162862891861 | epot = -18.4405866253331 | etot = -13.2825374166773 +936000 ekin = 2.42095423648383 | erot = 2.62651830339036 | epot = -18.3300099561839 | etot = -13.2825374163097 +937000 ekin = 2.40438434874151 | erot = 2.53973621394318 | epot = -18.2266579786711 | etot = -13.2825374159864 +938000 ekin = 2.38744919883856 | erot = 2.46512923461683 | epot = -18.1351158491807 | etot = -13.2825374157253 +939000 ekin = 2.37062067030574 | erot = 2.40593643917341 | epot = -18.0590945250148 | etot = -13.2825374155357 +940000 ekin = 2.35407564413747 | erot = 2.36465978775718 | epot = -18.0012728473171 | etot = -13.2825374154225 +941000 ekin = 2.33770002379755 | erot = 2.34297759096208 | epot = -17.9632150301481 | etot = -13.2825374153884 +942000 ekin = 2.32111004775224 | erot = 2.34167204163274 | epot = -17.9453195048215 | etot = -13.2825374154365 +943000 ekin = 2.30368578996793 | erot = 2.36056240830405 | epot = -17.9467856138391 | etot = -13.2825374155671 +944000 ekin = 2.28462216232314 | erot = 2.39846175787113 | epot = -17.9656213359689 | etot = -13.2825374157746 +945000 ekin = 2.26300913007938 | erot = 2.45319770726134 | epot = -17.9987442533843 | etot = -13.2825374160436 +946000 ekin = 2.23795189170117 | erot = 2.52174524353285 | epot = -18.0422345515794 | etot = -13.2825374163454 +947000 ekin = 2.20873145116087 | erot = 2.60050188059525 | epot = -18.091770748396 | etot = -13.2825374166398 +948000 ekin = 2.17498954714479 | erot = 2.685690959925 | epot = -18.1432179239527 | etot = -13.2825374168829 +949000 ekin = 2.13690579554511 | erot = 2.77382147697832 | epot = -18.1932646895605 | etot = -13.2825374170371 +950000 ekin = 2.09532426593736 | erot = 2.86208909954954 | epot = -18.23995078257 | etot = -13.2825374170831 +951000 ekin = 2.05179335117992 | erot = 2.94860198603871 | epot = -18.2829327542442 | etot = -13.2825374170256 +952000 ekin = 2.00850116862718 | erot = 3.03236285097458 | epot = -18.3234014364934 | etot = -13.2825374168917 +953000 ekin = 1.96811370669122 | erot = 3.11301524857533 | epot = -18.3636663719922 | etot = -13.2825374167257 +954000 ekin = 1.93354422355624 | erot = 3.19043207917699 | epot = -18.4065137193093 | etot = -13.2825374165761 +955000 ekin = 1.907692996046 | erot = 3.26426019428037 | epot = -18.4544906068132 | etot = -13.2825374164868 +956000 ekin = 1.89319483896647 | erot = 3.33353105128001 | epot = -18.5092633067365 | etot = -13.28253741649 +957000 ekin = 1.89220136882553 | erot = 3.39641763089531 | epot = -18.5711564163223 | etot = -13.2825374166015 +958000 ekin = 1.90621184477869 | erot = 3.45018116396587 | epot = -18.6389304255644 | etot = -13.2825374168199 +959000 ekin = 1.93595602669004 | erot = 3.49131884076761 | epot = -18.7098122845856 | etot = -13.2825374171279 +960000 ekin = 1.98132739841468 | erot = 3.51589596637559 | epot = -18.7797607822856 | etot = -13.2825374174953 +961000 ekin = 2.04135467368814 | erot = 3.5202262282781 | epot = -18.8441183198727 | etot = -13.2825374179065 +962000 ekin = 2.11395441204344 | erot = 3.50134462359753 | epot = -18.8978364539492 | etot = -13.2825374183082 +963000 ekin = 2.19624676723989 | erot = 3.45688460115197 | epot = -18.9356687870206 | etot = -13.2825374186287 +964000 ekin = 2.28502253674575 | erot = 3.38607259828084 | epot = -18.9536325538576 | etot = -13.282537418831 +965000 ekin = 2.37703902148585 | erot = 3.29004867798671 | epot = -18.9496251180009 | etot = -13.2825374185283 +966000 ekin = 2.47063968385215 | erot = 3.17235139654337 | epot = -18.9255284988459 | etot = -13.2825374184504 +967000 ekin = 2.56372995555254 | erot = 3.03797961239301 | epot = -18.8842469861485 | etot = -13.2825374182029 +968000 ekin = 2.65424152965125 | erot = 2.89333165879526 | epot = -18.83011060625 | etot = -13.2825374178035 +969000 ekin = 2.74102205813625 | erot = 2.74597895036798 | epot = -18.769538425812 | etot = -13.2825374173078 +970000 ekin = 2.82317857011101 | erot = 2.60419008501349 | epot = -18.7099060720296 | etot = -13.2825374169051 +971000 ekin = 2.89946896083441 | erot = 2.47604958426315 | epot = -18.658055961612 | etot = -13.2825374165144 +972000 ekin = 2.96927883277251 | erot = 2.36783972346085 | epot = -18.6196559725141 | etot = -13.2825374162807 +973000 ekin = 3.03160430380023 | erot = 2.28373901071249 | epot = -18.5978807307479 | etot = -13.2825374162352 +974000 ekin = 3.08487810119919 | erot = 2.22552920056088 | epot = -18.5929447181232 | etot = -13.2825374163631 +975000 ekin = 3.12708218363217 | erot = 2.1927093869337 | epot = -18.6023289871792 | etot = -13.2825374166133 +976000 ekin = 3.15606698430949 | erot = 2.18294126831253 | epot = -18.6215456695412 | etot = -13.2825374169192 +977000 ekin = 3.16994500357178 | erot = 2.19267118206454 | epot = -18.6451536028545 | etot = -13.2825374172182 +978000 ekin = 3.16742946522118 | erot = 2.21776877494467 | epot = -18.6677356576302 | etot = -13.2825374174643 +979000 ekin = 3.14804045998247 | erot = 2.25406876588806 | epot = -18.6846466435015 | etot = -13.282537417631 +980000 ekin = 3.11216367723466 | erot = 2.29776911466814 | epot = -18.6924702096109 | etot = -13.2825374177081 +981000 ekin = 3.06099215360332 | erot = 2.34569300138965 | epot = -18.6892225726894 | etot = -13.2825374176964 +982000 ekin = 2.99639965214887 | erot = 2.39544433518914 | epot = -18.6743814049394 | etot = -13.2825374176014 +983000 ekin = 2.92078844513084 | erot = 2.44547840887849 | epot = -18.6488042714436 | etot = -13.2825374174343 +984000 ekin = 2.83693459670618 | erot = 2.4950891273926 | epot = -18.6145611413098 | etot = -13.282537417211 +985000 ekin = 2.74783420133486 | erot = 2.54430433679905 | epot = -18.5746759550876 | etot = -13.2825374169537 +986000 ekin = 2.65654532109889 | erot = 2.59369131660279 | epot = -18.5327740543913 | etot = -13.2825374166896 +987000 ekin = 2.56602544086508 | erot = 2.64409904101799 | epot = -18.4926618983298 | etot = -13.2825374164468 +988000 ekin = 2.47897321649663 | erot = 2.69638105882724 | epot = -18.4578916915741 | etot = -13.2825374162503 +989000 ekin = 2.39763961716918 | erot = 2.75059396137744 | epot = -18.4307709947858 | etot = -13.2825374162392 +990000 ekin = 2.32368779821633 | erot = 2.80603342998527 | epot = -18.4122586443938 | etot = -13.2825374161922 +991000 ekin = 2.2582530149192 | erot = 2.86226671787586 | epot = -18.4030571490211 | etot = -13.282537416226 +992000 ekin = 2.20187988997662 | erot = 2.91825634939035 | epot = -18.4026736557096 | etot = -13.2825374163427 +993000 ekin = 2.15452775947043 | erot = 2.97231721293149 | epot = -18.4093823889398 | etot = -13.2825374165378 +994000 ekin = 2.11561176914432 | erot = 3.02214023523714 | epot = -18.4202894211813 | etot = -13.2825374167998 +995000 ekin = 2.08408161375424 | erot = 3.06489403643897 | epot = -18.4315130673008 | etot = -13.2825374171076 +996000 ekin = 2.05854312749319 | erot = 3.09743221500535 | epot = -18.4385127599264 | etot = -13.2825374174279 +997000 ekin = 2.03742523569505 | erot = 3.11662356420229 | epot = -18.4365862176148 | etot = -13.2825374177175 +998000 ekin = 2.01918449064732 | erot = 3.11978989603429 | epot = -18.42151180461 | etot = -13.2825374179284 +999000 ekin = 2.00252382621622 | erot = 3.10518925481745 | epot = -18.390250499052 | etot = -13.2825374180184 +1000000 ekin = 1.98658902577819 | erot = 3.07244217845672 | epot = -18.3415686221954 | etot = -13.2825374179605 + 1000000 0.088292846 -1.1874188 0.041070751 -1.0221862 -7.1515284e-05 +Loop time of 31.7925 on 1 procs for 1000000 steps with 16 atoms + +Performance: 27176.198 tau/day, 31453.933 timesteps/s +99.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 | 28.401 | 28.401 | 28.401 | 0.0 | 89.33 +Bond | 0.86019 | 0.86019 | 0.86019 | 0.0 | 2.71 +Neigh | 0.00018 | 0.00018 | 0.00018 | 0.0 | 0.00 +Comm | 0.16311 | 0.16311 | 0.16311 | 0.0 | 0.51 +Output | 7e-06 | 7e-06 | 7e-06 | 0.0 | 0.00 +Modify | 2.1003 | 2.1003 | 2.1003 | 0.0 | 6.61 +Other | | 0.2673 | | | 0.84 + +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: 93 ave 93 max 93 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 93 +Ave neighs/atom = 5.8125 +Ave special neighs/atom = 3.75 +Neighbor list builds = 6 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:31 diff --git a/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.4 b/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.4 new file mode 100644 index 0000000000..8a3a723a1e --- /dev/null +++ b/examples/USER/cgdna/examples/oxRNA2/duplex4/log.30Oct19.duplex4.g++.4 @@ -0,0 +1,1174 @@ +LAMMPS (30 Oct 2019) +variable number equal 4 +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.duplex4 + 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.000281 secs + read_data CPU = 0.003043 secs + +set atom * mass 3.1575 + 16 settings made for mass + +group all type 1 4 +16 atoms in group all + +# oxRNA2 bond interactions - FENE backbone +bond_style oxrna2/fene +bond_coeff * 2.0 0.25 0.761070781051 + +# oxRNA2 pair interactions +pair_style hybrid/overlay oxrna2/excv oxrna2/stk oxrna2/hbond oxrna2/xstk oxrna2/coaxstk oxrna2/dh + +pair_coeff * * oxrna2/excv 2.0 0.7 0.675 2.0 0.515 0.5 2.0 0.33 0.32 +pair_coeff * * oxrna2/stk seqdep ${T} 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 +pair_coeff * * oxrna2/stk seqdep 0.1 1.40206 2.77 6.0 0.43 0.93 0.35 0.78 0.9 0 0.95 0.9 0 0.95 1.3 0 0.8 1.3 0 0.8 2.0 0.65 2.0 0.65 +pair_coeff * * oxrna2/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 oxrna2/hbond seqdep 0.870439 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 oxrna2/hbond seqdep 0.870439 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 3 4 oxrna2/hbond seqdep 0.870439 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 * * oxrna2/xstk 59.9626 0.5 0.6 0.42 0.58 2.25 0.505 0.58 1.7 1.266 0.68 1.7 1.266 0.68 1.7 0.309 0.68 1.7 0.309 0.68 +pair_coeff * * oxrna2/coaxstk 80 0.5 0.6 0.42 0.58 2.0 2.592 0.65 1.3 0.151 0.8 0.9 0.685 0.95 0.9 0.685 0.95 2.0 -0.65 2.0 -0.65 +pair_coeff * * oxrna2/dh ${T} 0.5 1.02455 +pair_coeff * * oxrna2/dh 0.1 0.5 1.02455 + +# NVE ensemble +#fix 1 all nve/dotc/langevin 0.1 0.1 0.03 457145 angmom 10 +#fix 1 all nve/dot +fix 1 all nve/asphere + +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.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f %13.9f" + +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 = 3.3015 + ghost atom cutoff = 3.3015 + binsize = 1.65075, bins = 25 25 25 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxrna2/excv, perpetual + attributes: half, newton off + pair build: half/bin/newtoff + stencil: half/bin/3d/newtoff + bin: standard + (2) pair oxrna2/stk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (3) pair oxrna2/hbond, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (4) pair oxrna2/xstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (5) pair oxrna2/coaxstk, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none + (6) pair oxrna2/dh, perpetual, copy from (1) + attributes: half, newton off + pair build: copy + stencil: none + bin: none +0 ekin = 0 | erot = 0 | epot = -13.282537590974 | etot = -13.282537590974 +Per MPI rank memory allocation (min/avg/max) = 7.755 | 7.937 | 8.119 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -0.84341458 0.013255977 -0.8301586 -2.0169485e-05 +1000 ekin = 0.00448503054655829 | erot = 0.00825381229599554 | epot = -13.2952764343121 | etot = -13.2825375914696 +2000 ekin = 0.0179027901180383 | erot = 0.0327684151333158 | epot = -13.333208796773 | etot = -13.2825375915216 +3000 ekin = 0.0401478317723388 | erot = 0.0728240143062734 | epot = -13.3955094376812 | etot = -13.2825375916026 +4000 ekin = 0.0710654348932012 | erot = 0.127292706282676 | epot = -13.4808957328803 | etot = -13.2825375917044 +5000 ekin = 0.110480309743627 | erot = 0.194739074279345 | epot = -13.58775697584 | etot = -13.282537591817 +6000 ekin = 0.158231230694386 | erot = 0.273546913858364 | epot = -13.7143157364821 | etot = -13.2825375919294 +7000 ekin = 0.214206450831694 | erot = 0.362058396900661 | epot = -13.8588024397635 | etot = -13.2825375920312 +8000 ekin = 0.27837411184999 | erot = 0.458709556671591 | epot = -14.0196212606354 | etot = -13.2825375921138 +9000 ekin = 0.350802094030117 | erot = 0.562145629087582 | epot = -14.1954853152897 | etot = -13.282537592172 +10000 ekin = 0.431663021447632 | erot = 0.671302139461542 | epot = -14.3855027531133 | etot = -13.2825375922041 +11000 ekin = 0.521222365620092 | erot = 0.785442646223518 | epot = -14.5892026040564 | etot = -13.2825375922128 +12000 ekin = 0.619810398735201 | erot = 0.90415088836544 | epot = -14.8064988793047 | etot = -13.2825375922041 +13000 ekin = 0.727781531798581 | erot = 1.02728222251184 | epot = -15.0376013464965 | etot = -13.2825375921861 +14000 ekin = 0.845466747659119 | erot = 1.15488520186341 | epot = -15.2828895416906 | etot = -13.2825375921681 +15000 ekin = 0.973515286429056 | erot = 1.28640002432427 | epot = -15.5424529041403 | etot = -13.282537593387 +16000 ekin = 1.12323013751051 | erot = 1.4038749539854 | epot = -15.8096426839246 | etot = -13.2825375924286 +17000 ekin = 1.29769272832575 | erot = 1.51347784068601 | epot = -16.0937081607386 | etot = -13.2825375917268 +18000 ekin = 1.48565191084472 | erot = 1.63592970999597 | epot = -16.4041192134335 | etot = -13.2825375925929 +19000 ekin = 1.66750911163292 | erot = 1.77940241938649 | epot = -16.7294491246356 | etot = -13.2825375936162 +20000 ekin = 1.84148924290367 | erot = 1.93695511183614 | epot = -17.0609819484045 | etot = -13.2825375936647 +21000 ekin = 2.02307741366106 | erot = 2.09844265792887 | epot = -17.4040576653927 | etot = -13.2825375938028 +22000 ekin = 2.21183606977167 | erot = 2.26260708947227 | epot = -17.7569807531574 | etot = -13.2825375939135 +23000 ekin = 2.40735468792923 | erot = 2.42817202047232 | epot = -18.1180643024984 | etot = -13.2825375940969 +24000 ekin = 2.60896890448811 | erot = 2.59357882573777 | epot = -18.4850853245068 | etot = -13.2825375942809 +25000 ekin = 2.815801354773 | erot = 2.75706655666979 | epot = -18.8554055059558 | etot = -13.282537594513 +26000 ekin = 3.02680083558447 | erot = 2.91667946897181 | epot = -19.2260178993261 | etot = -13.2825375947698 +27000 ekin = 3.24067707260278 | erot = 3.07027299756425 | epot = -19.5934876652165 | etot = -13.2825375950495 +28000 ekin = 3.45601412953551 | erot = 3.21560615187967 | epot = -19.9541578767284 | etot = -13.2825375953133 +29000 ekin = 3.67136830813179 | erot = 3.35037905822876 | epot = -20.3042849619982 | etot = -13.2825375956377 +30000 ekin = 3.88476027224393 | erot = 3.47208481891771 | epot = -20.6393826871844 | etot = -13.2825375960227 +31000 ekin = 4.09387957878907 | erot = 3.57821385031972 | epot = -20.9546310254505 | etot = -13.2825375963417 +32000 ekin = 4.2966218534583 | erot = 3.6664860653108 | epot = -21.2456455154184 | etot = -13.2825375966493 +33000 ekin = 4.49089153394099 | erot = 3.73482555362516 | epot = -21.5082546845017 | etot = -13.2825375969356 +34000 ekin = 4.67464118182325 | erot = 3.78142516888949 | epot = -21.7386039479011 | etot = -13.2825375971883 +35000 ekin = 4.84586411782109 | erot = 3.80480460777856 | epot = -21.9332063229965 | etot = -13.2825375973968 +36000 ekin = 5.0027094048744 | erot = 3.80394535032719 | epot = -22.0891923527598 | etot = -13.2825375975582 +37000 ekin = 5.14355281474345 | erot = 3.77833709530338 | epot = -22.2044275077127 | etot = -13.2825375976659 +38000 ekin = 5.26699752588952 | erot = 3.72801268545681 | epot = -22.2775478090603 | etot = -13.282537597714 +39000 ekin = 5.37191151713971 | erot = 3.65359747923658 | epot = -22.3080465940747 | etot = -13.2825375976984 +40000 ekin = 5.45746010972539 | erot = 3.55633701588603 | epot = -22.2963347232318 | etot = -13.2825375976204 +41000 ekin = 5.52312188621432 | erot = 3.43809872369872 | epot = -22.2437582073857 | etot = -13.2825375974727 +42000 ekin = 5.56872044212123 | erot = 3.3013527933319 | epot = -22.1526108327172 | etot = -13.2825375972641 +43000 ekin = 5.59443660083054 | erot = 3.14910305123766 | epot = -22.0260772490709 | etot = -13.2825375970027 +44000 ekin = 5.60078634437832 | erot = 2.98477133565166 | epot = -21.8680952767313 | etot = -13.2825375967014 +45000 ekin = 5.58859564323475 | erot = 2.81204277265363 | epot = -21.6831760122637 | etot = -13.2825375963753 +46000 ekin = 5.55896198288938 | erot = 2.6346956216755 | epot = -21.4761952006028 | etot = -13.2825375960379 +47000 ekin = 5.51320424222089 | erot = 2.45646420183095 | epot = -21.2522060397504 | etot = -13.2825375956985 +48000 ekin = 5.45280176988658 | erot = 2.28095947573165 | epot = -21.0162988409789 | etot = -13.2825375953606 +49000 ekin = 5.37933239946777 | erot = 2.11161440403301 | epot = -20.7734843985466 | etot = -13.2825375950459 +50000 ekin = 5.29440598595322 | erot = 1.95156309993227 | epot = -20.5285066806364 | etot = -13.2825375947509 +51000 ekin = 5.19960275040365 | erot = 1.80366343983081 | epot = -20.2858037847169 | etot = -13.2825375944825 +52000 ekin = 5.09244091535893 | erot = 1.66034071449528 | epot = -20.0353192196147 | etot = -13.2825375897605 +53000 ekin = 5.00219098599359 | erot = 1.54003539006203 | epot = -19.8247639698989 | etot = -13.2825375938433 +54000 ekin = 4.9005832952689 | erot = 1.45132465506065 | epot = -19.6344455614694 | etot = -13.2825376111398 +55000 ekin = 4.70838087935279 | erot = 1.38368494594859 | epot = -19.374603433669 | etot = -13.2825376083676 +56000 ekin = 4.44064498303654 | erot = 1.42525549496225 | epot = -19.1484380668512 | etot = -13.2825375888524 +57000 ekin = 4.28012764787381 | erot = 1.59067222265449 | epot = -19.1533374833608 | etot = -13.2825376128325 +58000 ekin = 4.17606446205197 | erot = 1.69269591419354 | epot = -19.1512979674153 | etot = -13.2825375911698 +59000 ekin = 4.06748012934537 | erot = 1.75788112721229 | epot = -19.107898847714 | etot = -13.2825375911564 +60000 ekin = 3.95448823476477 | erot = 1.84391663061692 | epot = -19.0809424565338 | etot = -13.2825375911521 +61000 ekin = 3.83840387031379 | erot = 1.95003019237122 | epot = -19.0709716537089 | etot = -13.2825375910239 +62000 ekin = 3.72130809963139 | erot = 2.0750170389528 | epot = -19.0788627296236 | etot = -13.2825375910394 +63000 ekin = 3.60440089033071 | erot = 2.21773397929691 | epot = -19.1046724606766 | etot = -13.282537591049 +64000 ekin = 3.4889862142993 | erot = 2.37695650761868 | epot = -19.148480312971 | etot = -13.282537591053 +65000 ekin = 3.37647880025376 | erot = 2.55140907448341 | epot = -19.2104254657956 | etot = -13.2825375910584 +66000 ekin = 3.26833067403449 | erot = 2.73974236804954 | epot = -19.2906106331586 | etot = -13.2825375910746 +67000 ekin = 3.16594788215649 | erot = 2.94047174698095 | epot = -19.388957220252 | etot = -13.2825375911146 +68000 ekin = 3.0706053161234 | erot = 3.15188029478479 | epot = -19.5050232021006 | etot = -13.2825375911924 +69000 ekin = 2.98334905059876 | erot = 3.37190853325425 | epot = -19.6377951751748 | etot = -13.2825375913218 +70000 ekin = 2.90492955397934 | erot = 3.59802295152821 | epot = -19.7854900970212 | etot = -13.2825375915136 +71000 ekin = 2.8357237632926 | erot = 3.82715608397267 | epot = -19.9454174390302 | etot = -13.282537591765 +72000 ekin = 2.77568510799032 | erot = 4.05569348668108 | epot = -20.1139161867756 | etot = -13.2825375921042 +73000 ekin = 2.72437405649554 | erot = 4.27929863267833 | epot = -20.2862102816544 | etot = -13.2825375924805 +74000 ekin = 2.68098943200971 | erot = 4.49340310246777 | epot = -20.4569301273593 | etot = -13.2825375928818 +75000 ekin = 2.64445309406174 | erot = 4.69339307185924 | epot = -20.6203837591928 | etot = -13.2825375932718 +76000 ekin = 2.6135541520603 | erot = 4.87501053155987 | epot = -20.7711022772319 | etot = -13.2825375936117 +77000 ekin = 2.58710084062325 | erot = 5.03478939171986 | epot = -20.9044278262174 | etot = -13.2825375938743 +78000 ekin = 2.56403853914047 | erot = 5.17029283960992 | epot = -21.0168689727791 | etot = -13.2825375940288 +79000 ekin = 2.54361120788205 | erot = 5.28037161018718 | epot = -21.1065204121483 | etot = -13.2825375940791 +80000 ekin = 2.52540527324235 | erot = 5.36512720853055 | epot = -21.1730700758027 | etot = -13.2825375940298 +81000 ekin = 2.50929384303282 | erot = 5.42576598242984 | epot = -21.2175974194024 | etot = -13.2825375939398 +82000 ekin = 2.49524917644569 | erot = 5.46414530531101 | epot = -21.2419320755729 | etot = -13.2825375938162 +83000 ekin = 2.48334269593095 | erot = 5.4824203292205 | epot = -21.2483006188452 | etot = -13.2825375936938 +84000 ekin = 2.47365997802566 | erot = 5.48271691205612 | epot = -21.2389144836699 | etot = -13.2825375935881 +85000 ekin = 2.46626808184741 | erot = 5.46691083839012 | epot = -21.2157165137403 | etot = -13.2825375935028 +86000 ekin = 2.46123154184209 | erot = 5.43653398177587 | epot = -21.1803031170847 | etot = -13.2825375934667 +87000 ekin = 2.45852093879021 | erot = 5.39265692383558 | epot = -21.1337154560128 | etot = -13.282537593387 +88000 ekin = 2.45840646060141 | erot = 5.33627030736318 | epot = -21.0772143612568 | etot = -13.2825375932922 +89000 ekin = 2.46146480126854 | erot = 5.26838646846911 | epot = -21.012388863175 | etot = -13.2825375934373 +90000 ekin = 2.46773177835907 | erot = 5.18930366181577 | epot = -20.9395730335201 | etot = -13.2825375933453 +91000 ekin = 2.47726011905689 | erot = 5.09951749277907 | epot = -20.8593152050603 | etot = -13.2825375932243 +92000 ekin = 2.4907426196288 | erot = 5.00022791911722 | epot = -20.7735081318261 | etot = -13.2825375930801 +93000 ekin = 2.50902833057334 | erot = 4.89281259013229 | epot = -20.6843785136299 | etot = -13.2825375929243 +94000 ekin = 2.53301288183049 | erot = 4.77876912035663 | epot = -20.5943195949551 | etot = -13.282537592768 +95000 ekin = 2.56354598704884 | erot = 4.6596420581637 | epot = -20.5057256378358 | etot = -13.2825375926232 +96000 ekin = 2.60133194738592 | erot = 4.53693642149458 | epot = -20.4208059613811 | etot = -13.2825375925006 +97000 ekin = 2.6468471253709 | erot = 4.41204173729102 | epot = -20.341426455067 | etot = -13.2825375924051 +98000 ekin = 2.70029551800313 | erot = 4.28619503995253 | epot = -20.2690281502933 | etot = -13.2825375923376 +99000 ekin = 2.76159183076374 | erot = 4.1604816375425 | epot = -20.2046110606011 | etot = -13.2825375922949 +100000 ekin = 2.83036874776577 | erot = 4.0358752301046 | epot = -20.1487815701413 | etot = -13.2825375922709 +101000 ekin = 2.90599845693998 | erot = 3.9133007754067 | epot = -20.101836824607 | etot = -13.2825375922603 +102000 ekin = 2.98761606367611 | erot = 3.79369343963891 | epot = -20.0638470955759 | etot = -13.2825375922608 +103000 ekin = 3.07413620026815 | erot = 3.67802597580122 | epot = -20.0346997683425 | etot = -13.2825375922731 +104000 ekin = 3.16426099663664 | erot = 3.5672897363664 | epot = -20.0140883253055 | etot = -13.2825375923024 +105000 ekin = 3.25648344622817 | erot = 3.46242766269347 | epot = -20.0014487012771 | etot = -13.2825375923554 +106000 ekin = 3.34909407537385 | erot = 3.36423261094233 | epot = -19.995864278755 | etot = -13.2825375924388 +107000 ekin = 3.44019930697686 | erot = 3.27323316283083 | epot = -19.9959700623653 | etot = -13.2825375925576 +108000 ekin = 3.52775814523643 | erot = 3.18959025645848 | epot = -19.9998859944077 | etot = -13.2825375927128 +109000 ekin = 3.6096400910426 | erot = 3.11302339299944 | epot = -20.005201076944 | etot = -13.282537592902 +110000 ekin = 3.6837038852456 | erot = 3.04277828887611 | epot = -20.0090197672392 | etot = -13.2825375931175 +111000 ekin = 3.74789440567239 | erot = 2.97764201100065 | epot = -20.008074010021 | etot = -13.2825375933479 +112000 ekin = 3.80035415830488 | erot = 2.91600823448545 | epot = -19.998899986368 | etot = -13.2825375935777 +113000 ekin = 3.83954489146462 | erot = 2.8559933088985 | epot = -19.9780757941509 | etot = -13.2825375937878 +114000 ekin = 3.86437452036879 | erot = 2.79560177874322 | epot = -19.9425138930679 | etot = -13.2825375939559 +115000 ekin = 3.87432139555512 | erot = 2.7329343736022 | epot = -19.8897933632162 | etot = -13.2825375940589 +116000 ekin = 3.86954570193501 | erot = 2.66642221950647 | epot = -19.8185055155167 | etot = -13.2825375940752 +117000 ekin = 3.85097050791437 | erot = 2.59505981730791 | epot = -19.7285679191994 | etot = -13.2825375939772 +118000 ekin = 3.82031843896425 | erot = 2.5186641606976 | epot = -19.6215201934443 | etot = -13.2825375937824 +119000 ekin = 3.78008379969966 | erot = 2.43788144963801 | epot = -19.5005028428247 | etot = -13.282537593487 +120000 ekin = 3.73339325084474 | erot = 2.35417060362146 | epot = -19.3701014475778 | etot = -13.2825375931116 +121000 ekin = 3.68379362023552 | erot = 2.26974086129434 | epot = -19.2360720742189 | etot = -13.282537592689 +122000 ekin = 3.63497633455493 | erot = 2.187331073511 | epot = -19.1048450003246 | etot = -13.2825375922586 +123000 ekin = 3.59047168903083 | erot = 2.10992442969239 | epot = -18.9829337105828 | etot = -13.2825375918596 +124000 ekin = 3.55336069064751 | erot = 2.04044947797503 | epot = -18.8763477601473 | etot = -13.2825375915248 +125000 ekin = 3.52605275648501 | erot = 1.98151529341901 | epot = -18.7901056411792 | etot = -13.2825375912752 +126000 ekin = 3.51088386083619 | erot = 1.93492307727733 | epot = -18.7283445290526 | etot = -13.2825375909391 +127000 ekin = 3.51016542665117 | erot = 1.90135594382251 | epot = -18.6940589614207 | etot = -13.282537590947 +128000 ekin = 3.52366007691443 | erot = 1.88146923500183 | epot = -18.6876669021169 | etot = -13.2825375902006 +129000 ekin = 3.52804447870926 | erot = 1.87939379818771 | epot = -18.6899759099317 | etot = -13.2825376330347 +130000 ekin = 3.3912172753683 | erot = 1.9537535440301 | epot = -18.6275084102333 | etot = -13.2825375908349 +131000 ekin = 3.51597185423426 | erot = 2.06600773707507 | epot = -18.8645172230942 | etot = -13.2825376317848 +132000 ekin = 3.65680948155317 | erot = 2.09675964820366 | epot = -19.0361067214645 | etot = -13.2825375917077 +133000 ekin = 3.7826089844419 | erot = 2.11778864665351 | epot = -19.1829352240661 | etot = -13.2825375929707 +134000 ekin = 3.90291219401812 | erot = 2.13993246768579 | epot = -19.3253822549305 | etot = -13.2825375932266 +135000 ekin = 4.01307253292161 | erot = 2.16317596346837 | epot = -19.4587860898094 | etot = -13.2825375934194 +136000 ekin = 4.10942813981098 | erot = 2.18779054238556 | epot = -19.5797562757542 | etot = -13.2825375935576 +137000 ekin = 4.18918244084745 | erot = 2.21413018926333 | epot = -19.6858502237394 | etot = -13.2825375936286 +138000 ekin = 4.2505518072554 | erot = 2.24252417705063 | epot = -19.7756135779478 | etot = -13.2825375936417 +139000 ekin = 4.29264193993074 | erot = 2.27334414892585 | epot = -19.8485236824507 | etot = -13.2825375935941 +140000 ekin = 4.3154298106947 | erot = 2.30704736065629 | epot = -19.9050147648385 | etot = -13.2825375934876 +141000 ekin = 4.31969657449578 | erot = 2.34420108979774 | epot = -19.9464352576252 | etot = -13.2825375933317 +142000 ekin = 4.30689625825177 | erot = 2.38546661972142 | epot = -19.9749004711159 | etot = -13.2825375931427 +143000 ekin = 4.27897643633862 | erot = 2.43154322469966 | epot = -19.9930572539773 | etot = -13.282537592939 +144000 ekin = 4.23817759048806 | erot = 2.48305254316461 | epot = -20.0037677263992 | etot = -13.2825375927466 +145000 ekin = 4.18683687366753 | erot = 2.54040585524244 | epot = -20.009780321492 | etot = -13.2825375925821 +146000 ekin = 4.12722437776044 | erot = 2.60369949546926 | epot = -20.0134614656893 | etot = -13.2825375924596 +147000 ekin = 4.06142641942185 | erot = 2.67262771534978 | epot = -20.0165917271585 | etot = -13.2825375923869 +148000 ekin = 3.99128035690908 | erot = 2.74643868481997 | epot = -20.020256634094 | etot = -13.282537592365 +149000 ekin = 3.91835859675011 | erot = 2.82393987441806 | epot = -20.0248360635573 | etot = -13.2825375923891 +150000 ekin = 3.84399502540833 | erot = 2.90355368904256 | epot = -20.0300863068997 | etot = -13.2825375924488 +151000 ekin = 3.76934462696621 | erot = 2.98342057410539 | epot = -20.0353027936016 | etot = -13.28253759253 +152000 ekin = 3.69546503896268 | erot = 3.06154297168208 | epot = -20.0395456032601 | etot = -13.2825375926153 +153000 ekin = 3.62340677772804 | erot = 3.13595781467784 | epot = -20.0419021850934 | etot = -13.2825375926875 +154000 ekin = 3.55429442921638 | erot = 3.20491770297356 | epot = -20.0417497249215 | etot = -13.2825375927316 +155000 ekin = 3.48935808553542 | erot = 3.267033764948 | epot = -20.0389294432276 | etot = -13.2825375927442 +156000 ekin = 3.42995719397451 | erot = 3.32146386703958 | epot = -20.0339586537004 | etot = -13.2825375926863 +157000 ekin = 3.37758377439308 | erot = 3.3680769357291 | epot = -20.0281983027503 | etot = -13.2825375926282 +158000 ekin = 3.32977839475207 | erot = 3.40502394976649 | epot = -20.0173399361884 | etot = -13.2825375916698 +159000 ekin = 3.28790229188182 | erot = 3.43232801111001 | epot = -20.0027678906269 | etot = -13.2825375876351 +160000 ekin = 3.28279951728226 | erot = 3.4645745488256 | epot = -20.0299116571476 | etot = -13.2825375910398 +161000 ekin = 3.29006841785755 | erot = 3.48756894666592 | epot = -20.060174952488 | etot = -13.2825375879645 +162000 ekin = 3.30320279764929 | erot = 3.5006454181618 | epot = -20.0863858038415 | etot = -13.2825375880305 +163000 ekin = 3.3268044536015 | erot = 3.5070397924055 | epot = -20.1163818341639 | etot = -13.2825375881569 +164000 ekin = 3.35978204864461 | erot = 3.50639799900104 | epot = -20.1487176359757 | etot = -13.2825375883301 +165000 ekin = 3.40052448161875 | erot = 3.49807859199056 | epot = -20.181140662133 | etot = -13.2825375885237 +166000 ekin = 3.44710440323471 | erot = 3.48135096319333 | epot = -20.2109929551299 | etot = -13.2825375887019 +167000 ekin = 3.49756483136592 | erot = 3.45565303648324 | epot = -20.2357554566773 | etot = -13.2825375888282 +168000 ekin = 3.55023572858368 | erot = 3.42084325030349 | epot = -20.2536165677586 | etot = -13.2825375888714 +169000 ekin = 3.60406985696714 | erot = 3.37750569995069 | epot = -20.2641131456955 | etot = -13.2825375887777 +170000 ekin = 3.41798406778751 | erot = 3.07782048145922 | epot = -19.778342066862 | etot = -13.2825375176153 +171000 ekin = 3.24552871157498 | erot = 2.73637390316101 | epot = -19.2644400103033 | etot = -13.2825373955674 +172000 ekin = 3.78367855050775 | erot = 3.07274537488996 | epot = -20.1389614956815 | etot = -13.2825375702838 +173000 ekin = 4.03457273059295 | erot = 3.18336469108423 | epot = -20.5004749222008 | etot = -13.2825375005236 +174000 ekin = 4.14002439985893 | erot = 3.16763893899956 | epot = -20.5902008391742 | etot = -13.2825375003158 +175000 ekin = 4.24061478727453 | erot = 3.15086312051272 | epot = -20.6740154078936 | etot = -13.2825375001064 +176000 ekin = 4.33750550891526 | erot = 3.13552610061259 | epot = -20.7555691095042 | etot = -13.2825374999763 +177000 ekin = 4.43118634626137 | erot = 3.12342668205163 | epot = -20.8371505282951 | etot = -13.2825374999821 +178000 ekin = 4.52112038535783 | erot = 3.11516996838801 | epot = -20.9188278538849 | etot = -13.282537500139 +179000 ekin = 4.60569122910417 | erot = 3.10997891303252 | epot = -20.998207642551 | etot = -13.2825375004143 +180000 ekin = 4.68248742105047 | erot = 3.1058753404107 | epot = -21.0709002621979 | etot = -13.2825375007368 +181000 ekin = 4.74885008880596 | erot = 3.10016969122731 | epot = -21.1315572810529 | etot = -13.2825375010196 +182000 ekin = 4.8025200424072 | erot = 3.09010778323257 | epot = -21.1751653268254 | etot = -13.2825375011856 +183000 ekin = 4.84185836209202 | erot = 3.07355401450771 | epot = -21.1979498780484 | etot = -13.2825375014487 +184000 ekin = 4.86305938218088 | erot = 3.04972947015888 | epot = -21.1953263537842 | etot = -13.2825375014444 +185000 ekin = 4.86484048379678 | erot = 3.01830532387275 | epot = -21.1656833089538 | etot = -13.2825375012843 +186000 ekin = 4.84781115921716 | erot = 2.97987576046156 | epot = -21.1102244206809 | etot = -13.2825375010021 +187000 ekin = 4.81357764335378 | erot = 2.93597501879657 | epot = -21.0320901627985 | etot = -13.2825375006482 +188000 ekin = 4.76439584097053 | erot = 2.8887503176224 | epot = -20.9356836588659 | etot = -13.282537500273 +189000 ekin = 4.70282021343345 | erot = 2.84056846871519 | epot = -20.8259261820667 | etot = -13.282537499918 +190000 ekin = 4.63141632940784 | erot = 2.79367442377921 | epot = -20.7076282527974 | etot = -13.2825374996104 +191000 ekin = 4.55257205219614 | erot = 2.74995133907631 | epot = -20.5850608906324 | etot = -13.28253749936 +192000 ekin = 4.4684144513739 | erot = 2.71080835143519 | epot = -20.461760301973 | etot = -13.2825374991639 +193000 ekin = 4.38080987485654 | erot = 2.67717312167521 | epot = -20.3405204955454 | etot = -13.2825374990136 +194000 ekin = 4.29140314493119 | erot = 2.64952891334815 | epot = -20.223469557183 | etot = -13.2825374989037 +195000 ekin = 4.20164846020117 | erot = 2.62793199519477 | epot = -20.1121179542326 | etot = -13.2825374988367 +196000 ekin = 4.11279973688578 | erot = 2.61197297306555 | epot = -20.0073102087732 | etot = -13.2825374988219 +197000 ekin = 4.02585897192346 | erot = 2.6006960732789 | epot = -19.9090925440713 | etot = -13.2825374988689 +198000 ekin = 3.94151021740631 | erot = 2.59254113732279 | epot = -19.8165888537068 | etot = -13.2825374989777 +199000 ekin = 3.8600892057151 | erot = 2.58539978552207 | epot = -19.7280264903664 | etot = -13.2825374991292 +200000 ekin = 3.78163650515432 | erot = 2.57685633277492 | epot = -19.641030337214 | etot = -13.2825374992847 +201000 ekin = 3.70604145366902 | erot = 2.56461316993936 | epot = -19.5531921230034 | etot = -13.2825374993951 +202000 ekin = 3.63323784111755 | erot = 2.54700321074615 | epot = -19.4627785512822 | etot = -13.2825374994185 +203000 ekin = 3.56337600429993 | erot = 2.52342549129483 | epot = -19.3693389949304 | etot = -13.2825374993357 +204000 ekin = 3.49690618989434 | erot = 2.49455276327548 | epot = -19.2739964523247 | etot = -13.2825374991549 +205000 ekin = 3.4345533876734 | erot = 2.46224574346295 | epot = -19.1793366300441 | etot = -13.2825374989078 +206000 ekin = 3.37721205721461 | erot = 2.42921548153362 | epot = -19.0889650373856 | etot = -13.2825374986374 +207000 ekin = 3.32580575275846 | erot = 2.39854397251164 | epot = -19.0068872236569 | etot = -13.2825374983868 +208000 ekin = 3.28114891016592 | erot = 2.3731881465479 | epot = -18.9368745549049 | etot = -13.2825374981911 +209000 ekin = 3.24383236357031 | erot = 2.35556506548857 | epot = -18.881934927133 | etot = -13.2825374980741 +210000 ekin = 3.21413821976384 | erot = 2.34727297364657 | epot = -18.8439486914573 | etot = -13.2825374980469 +211000 ekin = 3.1919920439607 | erot = 2.34895966766535 | epot = -18.8234892097349 | etot = -13.2825374981088 +212000 ekin = 3.17695628121283 | erot = 2.36032147203272 | epot = -18.8198152514957 | etot = -13.2825374982501 +213000 ekin = 3.16826455951627 | erot = 2.3802017195472 | epot = -18.8310037775173 | etot = -13.2825374984538 +214000 ekin = 3.16489343854745 | erot = 2.40676052174862 | epot = -18.8541914589943 | etot = -13.2825374986982 +215000 ekin = 3.16566474352266 | erot = 2.43769738040411 | epot = -18.8858996228842 | etot = -13.2825374989574 +216000 ekin = 3.16936807503371 | erot = 2.47051711067938 | epot = -18.922422684916 | etot = -13.2825374992029 +217000 ekin = 3.16266988026928 | erot = 2.47868467133945 | epot = -18.9238920507811 | etot = -13.2825374991723 +218000 ekin = 3.17835235865462 | erot = 2.45704329444748 | epot = -18.9179331413782 | etot = -13.2825374882761 +219000 ekin = 3.26524817202182 | erot = 2.48120766962804 | epot = -19.0289933444494 | etot = -13.2825375027995 +220000 ekin = 3.3108366379572 | erot = 2.50602061547593 | epot = -19.0993947418604 | etot = -13.2825374884273 +221000 ekin = 3.33748530919814 | erot = 2.52276996124463 | epot = -19.1427927588605 | etot = -13.2825374884177 +222000 ekin = 3.36243211589585 | erot = 2.53668587910087 | epot = -19.1816554833759 | etot = -13.2825374883791 +223000 ekin = 3.38541896904289 | erot = 2.54888617169885 | epot = -19.2168426290795 | etot = -13.2825374883378 +224000 ekin = 3.40625812508042 | erot = 2.56049920868685 | epot = -19.2492948220808 | etot = -13.2825374883136 +225000 ekin = 3.42484722909655 | erot = 2.57234499865789 | epot = -19.2797297160694 | etot = -13.2825374883149 +226000 ekin = 3.44121067431426 | erot = 2.5847203663376 | epot = -19.3084685289965 | etot = -13.2825374883446 +227000 ekin = 3.45552721377372 | erot = 2.59730386680816 | epot = -19.3353685689828 | etot = -13.2825374884009 +228000 ekin = 3.46810974282108 | erot = 2.60916931207508 | epot = -19.3598165433769 | etot = -13.2825374884807 +229000 ekin = 3.47932676313057 | erot = 2.61888809507148 | epot = -19.3807523467825 | etot = -13.2825374885804 +230000 ekin = 3.48948003513572 | erot = 2.62469570471801 | epot = -19.3967132285493 | etot = -13.2825374886956 +231000 ekin = 3.49867242979287 | erot = 2.62469374220123 | epot = -19.4059036608136 | etot = -13.2825374888195 +232000 ekin = 3.50671171842553 | erot = 2.61706130327851 | epot = -19.4063105106456 | etot = -13.2825374889415 +233000 ekin = 3.51309701132019 | erot = 2.60026316425614 | epot = -19.3958976646192 | etot = -13.2825374890429 +234000 ekin = 3.51712117494225 | erot = 2.57326085610047 | epot = -19.3729195201389 | etot = -13.2825374890961 +235000 ekin = 3.51809173982046 | erot = 2.53573892922922 | epot = -19.336368158117 | etot = -13.2825374890673 +236000 ekin = 3.51562949139228 | erot = 2.48833922691179 | epot = -19.2865062072283 | etot = -13.2825374889242 +237000 ekin = 3.50996386129181 | erot = 2.43285732073755 | epot = -19.2253586706778 | etot = -13.2825374886484 +238000 ekin = 3.50212794781223 | erot = 2.37232394343651 | epot = -19.1569893794947 | etot = -13.2825374882459 +239000 ekin = 3.49397580570105 | erot = 2.3108975006263 | epot = -19.0874107940784 | etot = -13.282537487751 +240000 ekin = 3.48799489984471 | erot = 2.25353771706539 | epot = -19.0240701041317 | etot = -13.2825374872216 +241000 ekin = 3.48694744152127 | erot = 2.20549386842306 | epot = -18.9749787966723 | etot = -13.2825374867279 +242000 ekin = 3.4934176974057 | erot = 2.17169223103266 | epot = -18.947647414778 | etot = -13.2825374863397 +243000 ekin = 3.50935803683896 | erot = 2.15612557817141 | epot = -18.9480211011254 | etot = -13.282537486115 +244000 ekin = 3.53571412219025 | erot = 2.16133426987283 | epot = -18.9795858781565 | etot = -13.2825374860934 +245000 ekin = 3.57218201231882 | erot = 2.18803987534321 | epot = -19.0427593739541 | etot = -13.2825374862921 +246000 ekin = 3.61712090977394 | erot = 2.23496626996872 | epot = -19.1346246664479 | etot = -13.2825374867053 +247000 ekin = 3.66762313707291 | erot = 2.29886938892395 | epot = -19.2490300132999 | etot = -13.282537487303 +248000 ekin = 3.71973304097767 | erot = 2.37479253662205 | epot = -19.3770630656317 | etot = -13.282537488032 +249000 ekin = 3.76879884759244 | erot = 2.45655776432051 | epot = -19.5078941007293 | etot = -13.2825374888163 +250000 ekin = 3.80993596354176 | erot = 2.5374803002976 | epot = -19.6299537534029 | etot = -13.2825374895636 +251000 ekin = 3.83856187827227 | erot = 2.6112453760505 | epot = -19.7323447444996 | etot = -13.2825374901768 +252000 ekin = 3.85094160348931 | erot = 2.67282602420732 | epot = -19.8063051182674 | etot = -13.2825374905708 +253000 ekin = 3.84466267221602 | erot = 2.71927370140011 | epot = -19.8464738643058 | etot = -13.2825374906897 +254000 ekin = 3.81895334833917 | erot = 2.75020964906172 | epot = -19.8517004879211 | etot = -13.2825374905202 +255000 ekin = 3.77477712370886 | erot = 2.76789565653784 | epot = -19.8252102703423 | etot = -13.2825374900956 +256000 ekin = 3.71467746908689 | erot = 2.7768542145932 | epot = -19.7740691731695 | etot = -13.2825374894894 +257000 ekin = 3.64239785971663 | erot = 2.78310854270393 | epot = -19.7080438912214 | etot = -13.2825374888008 +258000 ekin = 3.56234912667125 | erot = 2.79319020432275 | epot = -19.6380768191301 | etot = -13.2825374881361 +259000 ekin = 3.47902170398649 | erot = 2.81309489223277 | epot = -19.5746540838101 | etot = -13.2825374875908 +260000 ekin = 3.39644765746229 | erot = 2.84735592157313 | epot = -19.5263410662708 | etot = -13.2825374872354 +261000 ekin = 3.31779785755677 | erot = 2.89836390677638 | epot = -19.4986992514409 | etot = -13.2825374871077 +262000 ekin = 3.24516405277705 | erot = 2.96601202360051 | epot = -19.4937135635853 | etot = -13.2825374872077 +263000 ekin = 3.179546945306 | erot = 3.04771661067476 | epot = -19.5098010434848 | etot = -13.2825374875041 +264000 ekin = 3.12100159498149 | erot = 3.13875568824824 | epot = -19.5422947711671 | etot = -13.2825374879374 +265000 ekin = 3.06890996951173 | erot = 3.23291804297549 | epot = -19.5843655009186 | etot = -13.2825374884314 +266000 ekin = 3.02230555156918 | erot = 3.3233525253047 | epot = -19.6281955657826 | etot = -13.2825374889087 +267000 ekin = 2.98016989218907 | erot = 3.40345614747432 | epot = -19.6661635289706 | etot = -13.2825374893072 +268000 ekin = 2.94163501488653 | erot = 3.46763177350614 | epot = -19.6918042779846 | etot = -13.2825374895919 +269000 ekin = 2.90604069318559 | erot = 3.5117562623884 | epot = -19.7003344453572 | etot = -13.2825374897832 +270000 ekin = 2.87284037255953 | erot = 3.53329819601925 | epot = -19.688676058427 | etot = -13.2825374898482 +271000 ekin = 2.8415668881788 | erot = 3.53141495904858 | epot = -19.6555193370572 | etot = -13.2825374898299 +272000 ekin = 2.81169493920591 | erot = 3.50673144119824 | epot = -19.6009638701438 | etot = -13.2825374897396 +273000 ekin = 2.78262532285067 | erot = 3.46115906465187 | epot = -19.5263218770816 | etot = -13.282537489579 +274000 ekin = 2.75380981305629 | erot = 3.39781487150763 | epot = -19.4341621738888 | etot = -13.2825374893249 +275000 ekin = 2.7249735792436 | erot = 3.32097131771962 | epot = -19.3284823859411 | etot = -13.2825374889778 +276000 ekin = 2.6963100293489 | erot = 3.23585259467393 | epot = -19.2147001125781 | etot = -13.2825374885553 +277000 ekin = 2.66855210196835 | erot = 3.14826501869141 | epot = -19.0993546087612 | etot = -13.2825374881014 +278000 ekin = 2.64286719085315 | erot = 3.06403640806022 | epot = -18.9894410865903 | etot = -13.282537487677 +279000 ekin = 2.62061028223249 | erot = 2.98836162249181 | epot = -18.8915093920665 | etot = -13.2825374873422 +280000 ekin = 2.60303022005452 | erot = 2.92520891289514 | epot = -18.810776620089 | etot = -13.2825374871393 +281000 ekin = 2.59103448458187 | erot = 2.87693253510413 | epot = -18.7505045067671 | etot = -13.2825374870811 +282000 ekin = 2.58508390620669 | erot = 2.84417540765184 | epot = -18.7117968010092 | etot = -13.2825374871506 +283000 ekin = 2.58523135936813 | erot = 2.82606103956109 | epot = -18.6938298862392 | etot = -13.2825374873099 +284000 ekin = 2.59126091870129 | erot = 2.82059473157291 | epot = -18.6943931377889 | etot = -13.2825374875147 +285000 ekin = 2.60284631077899 | erot = 2.82514472712939 | epot = -18.7105285256372 | etot = -13.2825374877289 +286000 ekin = 2.61964775974011 | erot = 2.83687342635554 | epot = -18.7390586740297 | etot = -13.2825374879341 +287000 ekin = 2.6416789431732 | erot = 2.85285066093716 | epot = -18.7770670922847 | etot = -13.2825374881743 +288000 ekin = 2.6687167813734 | erot = 2.8702293010975 | epot = -18.8214835708707 | etot = -13.2825374883998 +289000 ekin = 2.69931643718338 | erot = 2.88698660757789 | epot = -18.8688405333582 | etot = -13.282537488597 +290000 ekin = 2.73194963658688 | erot = 2.90163654912622 | epot = -18.9161236744781 | etot = -13.282537488765 +291000 ekin = 2.76502957907631 | erot = 2.91324911168519 | epot = -18.9608161796562 | etot = -13.2825374888947 +292000 ekin = 2.79700561900786 | erot = 2.92149576190804 | epot = -19.0010388698871 | etot = -13.2825374889712 +293000 ekin = 2.82654239554868 | erot = 2.92669002283791 | epot = -19.0357699073648 | etot = -13.2825374889783 +294000 ekin = 2.85272969462551 | erot = 2.92951972788748 | epot = -19.064786911459 | etot = -13.282537488946 +295000 ekin = 2.87508597590273 | erot = 2.9311082644752 | epot = -19.0887317291887 | etot = -13.2825374888108 +296000 ekin = 2.8937804752686 | erot = 2.93349300132756 | epot = -19.1098109651871 | etot = -13.2825374885909 +297000 ekin = 2.90976516785128 | erot = 2.93912517174271 | epot = -19.1314278279134 | etot = -13.2825374883194 +298000 ekin = 2.92469477926885 | erot = 2.95047845944604 | epot = -19.1577107267523 | etot = -13.2825374880374 +299000 ekin = 2.94065805823525 | erot = 2.96967690612477 | epot = -19.192872452154 | etot = -13.282537487794 +300000 ekin = 2.95980003469444 | erot = 2.99812642991887 | epot = -19.2404639522491 | etot = -13.2825374876358 +301000 ekin = 2.9839127297722 | erot = 3.03621252497576 | epot = -19.3026627423455 | etot = -13.2825374875976 +302000 ekin = 3.01408971368584 | erot = 3.08312901017938 | epot = -19.3797562115566 | etot = -13.2825374876914 +303000 ekin = 3.05053302665562 | erot = 3.13689255668877 | epot = -19.4699630712467 | etot = -13.2825374879023 +304000 ekin = 3.08584972584791 | erot = 3.19556015973973 | epot = -19.563947375247 | etot = -13.2825374896594 +305000 ekin = 3.11890909070429 | erot = 3.26281224727038 | epot = -19.6642588266134 | etot = -13.2825374886387 +306000 ekin = 3.16699270587699 | erot = 3.33070506272307 | epot = -19.7802352601689 | etot = -13.2825374915688 +307000 ekin = 3.22023032257454 | erot = 3.3799777181521 | epot = -19.8827455298078 | etot = -13.2825374890812 +308000 ekin = 3.2726873966337 | erot = 3.41969099128558 | epot = -19.974915877149 | etot = -13.2825374892298 +309000 ekin = 3.32280425481262 | erot = 3.44976402097258 | epot = -20.0551057651207 | etot = -13.2825374893356 +310000 ekin = 3.36903652740989 | erot = 3.46970323071698 | epot = -20.1212772475628 | etot = -13.282537489436 +311000 ekin = 3.40972253534481 | erot = 3.47940229945176 | epot = -20.1716623243629 | etot = -13.2825374895663 +312000 ekin = 3.44308129109209 | erot = 3.47898447383071 | epot = -20.2046032544282 | etot = -13.2825374895054 +313000 ekin = 3.46879202758971 | erot = 3.47087869841085 | epot = -20.2222082156542 | etot = -13.2825374896536 +314000 ekin = 3.48565385463582 | erot = 3.45582059749585 | epot = -20.2240119419411 | etot = -13.2825374898094 +315000 ekin = 3.49216313291107 | erot = 3.43373104095289 | epot = -20.2084316637861 | etot = -13.2825374899221 +316000 ekin = 3.4873621330349 | erot = 3.4048256725594 | epot = -20.1747252955317 | etot = -13.2825374899373 +317000 ekin = 3.4699413250759 | erot = 3.36841330847627 | epot = -20.1208921250426 | etot = -13.2825374914904 +318000 ekin = 3.43614022048349 | erot = 3.32066657788322 | epot = -20.0393442896741 | etot = -13.2825374913073 +319000 ekin = 3.38694293952412 | erot = 3.26364910698136 | epot = -19.933129537441 | etot = -13.2825374909355 +320000 ekin = 3.32506744212997 | erot = 3.20113650606391 | epot = -19.8087414386369 | etot = -13.282537490443 +321000 ekin = 3.25415482891508 | erot = 3.13766117543029 | epot = -19.6743534942649 | etot = -13.2825374899195 +322000 ekin = 3.17813669787313 | erot = 3.07780020747427 | epot = -19.5384743947971 | etot = -13.2825374894497 +323000 ekin = 3.10066688251982 | erot = 3.0254908818081 | epot = -19.4086952534143 | etot = -13.2825374890864 +324000 ekin = 3.02479637479388 | erot = 2.98355122494391 | epot = -19.2908850885811 | etot = -13.2825374888433 +325000 ekin = 2.95294332411383 | erot = 2.95347420684896 | epot = -19.1889550196676 | etot = -13.2825374887048 +326000 ekin = 2.88706743997792 | erot = 2.93544936652566 | epot = -19.1050542951497 | etot = -13.2825374886462 +327000 ekin = 2.82887581624799 | erot = 2.92851219862454 | epot = -19.0399255035216 | etot = -13.2825374886491 +328000 ekin = 2.77990830068301 | erot = 2.93074772300687 | epot = -18.9931935123953 | etot = -13.2825374887054 +329000 ekin = 2.74145002280153 | erot = 2.9395401663855 | epot = -18.9635276779975 | etot = -13.2825374888105 +330000 ekin = 2.71432845550434 | erot = 2.95189909643542 | epot = -18.948765040893 | etot = -13.2825374889532 +331000 ekin = 2.69870867087714 | erot = 2.96486608415688 | epot = -18.9461122441487 | etot = -13.2825374891147 +332000 ekin = 2.69398517732769 | erot = 2.97593512180702 | epot = -18.9524577884083 | etot = -13.2825374892736 +333000 ekin = 2.69881348537541 | erot = 2.98337443171444 | epot = -18.9647254065019 | etot = -13.282537489412 +334000 ekin = 2.71127609678388 | erot = 2.98637176000176 | epot = -18.9801853463025 | etot = -13.2825374895168 +335000 ekin = 2.72916096429869 | erot = 2.9850116550983 | epot = -18.9967101089713 | etot = -13.2825374895743 +336000 ekin = 2.75032164400772 | erot = 2.98016551096382 | epot = -19.0130246445397 | etot = -13.2825374895682 +337000 ekin = 2.77304615866046 | erot = 2.97336445321142 | epot = -19.0289481013616 | etot = -13.2825374894897 +338000 ekin = 2.79631213711493 | erot = 2.96664518651861 | epot = -19.0454948129846 | etot = -13.2825374893511 +339000 ekin = 2.81982513095444 | erot = 2.96230352229829 | epot = -19.0646661424439 | etot = -13.2825374891912 +340000 ekin = 2.84381599358321 | erot = 2.96250923740585 | epot = -19.0888627200581 | etot = -13.282537489069 +341000 ekin = 2.86861716322387 | erot = 2.96879944354266 | epot = -19.1199540958289 | etot = -13.2825374890623 +342000 ekin = 2.8942330530774 | erot = 2.9815983091965 | epot = -19.1583688514559 | etot = -13.282537489182 +343000 ekin = 2.92230469127694 | erot = 3.00151195978259 | epot = -19.2063541396131 | etot = -13.2825374885536 +344000 ekin = 2.95328542679254 | erot = 3.02739469587761 | epot = -19.263217611886 | etot = -13.2825374892158 +345000 ekin = 2.98288076792924 | erot = 3.0539773023115 | epot = -19.319395560126 | etot = -13.2825374898853 +346000 ekin = 3.00683622806662 | erot = 3.07579634903604 | epot = -19.3651700675394 | etot = -13.2825374904367 +347000 ekin = 3.02168203920098 | erot = 3.08832269782129 | epot = -19.3925422278017 | etot = -13.2825374907794 +348000 ekin = 3.02528371459624 | erot = 3.08873432783917 | epot = -19.3965555333216 | etot = -13.2825374908862 +349000 ekin = 3.01708434472178 | erot = 3.07610751269672 | epot = -19.3757293482069 | etot = -13.2825374907884 +350000 ekin = 2.99803087494797 | erot = 3.05108999688778 | epot = -19.3316583623806 | etot = -13.2825374905448 +351000 ekin = 2.97033325354683 | erot = 3.0153936212866 | epot = -19.2682643650312 | etot = -13.2825374901978 +352000 ekin = 2.9375545389088 | erot = 2.97175102427437 | epot = -19.1918430530028 | etot = -13.2825374898196 +353000 ekin = 2.90330530002109 | erot = 2.9229126111419 | epot = -19.1087554005707 | etot = -13.2825374894077 +354000 ekin = 2.87126755833817 | erot = 2.8717032112567 | epot = -19.0255082585642 | etot = -13.2825374889693 +355000 ekin = 2.8452063966084 | erot = 2.82119115452554 | epot = -18.9489350396508 | etot = -13.2825374885168 +356000 ekin = 2.8287863971617 | erot = 2.77463213289955 | epot = -18.8859560181414 | etot = -13.2825374880802 +357000 ekin = 2.82589501110838 | erot = 2.73507904234315 | epot = -18.8435115424251 | etot = -13.2825374889736 +358000 ekin = 2.83567543256236 | erot = 2.69990343571512 | epot = -18.8181163574533 | etot = -13.2825374891758 +359000 ekin = 2.85413863003171 | erot = 2.66477535390693 | epot = -18.8014514734629 | etot = -13.2825374895243 +360000 ekin = 2.87797108635789 | erot = 2.62716069413247 | epot = -18.7876692705243 | etot = -13.2825374900339 +361000 ekin = 2.90295419334349 | erot = 2.58324525246655 | epot = -18.7687369364383 | etot = -13.2825374906282 +362000 ekin = 2.92446718933245 | erot = 2.52862237257584 | epot = -18.7356270530339 | etot = -13.2825374911256 +363000 ekin = 2.93848759933288 | erot = 2.4598916464099 | epot = -18.6809167370418 | etot = -13.282537491299 +364000 ekin = 2.94271150164537 | erot = 2.37661313123448 | epot = -18.6018621239963 | etot = -13.2825374911165 +365000 ekin = 2.93600170081407 | erot = 2.28250131434272 | epot = -18.5010405056271 | etot = -13.2825374904703 +366000 ekin = 2.91934189957468 | erot = 2.18525996401723 | epot = -18.3871393531676 | etot = -13.2825374895757 +367000 ekin = 2.89548895825523 | erot = 2.09468885645295 | epot = -18.272715303391 | etot = -13.2825374886828 +368000 ekin = 2.86763306547941 | erot = 2.02026878405696 | epot = -18.170439337522 | etot = -13.2825374879856 +369000 ekin = 2.83845106986062 | erot = 1.96931673437145 | epot = -18.0903052917991 | etot = -13.282537487567 +370000 ekin = 2.80963551309293 | erot = 1.9461845593661 | epot = -18.0383575598726 | etot = -13.2825374874135 +371000 ekin = 2.78188668089845 | erot = 1.95235490032886 | epot = -18.0167790686903 | etot = -13.282537487463 +372000 ekin = 2.75518266190969 | erot = 1.98699478725925 | epot = -18.0247149368153 | etot = -13.2825374876464 +373000 ekin = 2.72912880528294 | erot = 2.04757125854723 | epot = -18.059237551743 | etot = -13.2825374879128 +374000 ekin = 2.7032481730958 | erot = 2.13030562163336 | epot = -18.116091282967 | etot = -13.2825374882379 +375000 ekin = 2.67714701016783 | erot = 2.230398201263 | epot = -18.190082700051 | etot = -13.2825374886202 +376000 ekin = 2.65054772278835 | erot = 2.34206662745015 | epot = -18.2751518393088 | etot = -13.2825374890703 +377000 ekin = 2.6232286660267 | erot = 2.4585298333916 | epot = -18.3642959890073 | etot = -13.282537489589 +378000 ekin = 2.59495135703951 | erot = 2.57214449993273 | epot = -18.4496333471167 | etot = -13.2825374901445 +379000 ekin = 2.56546707826761 | erot = 2.67491697597518 | epot = -18.5229215449019 | etot = -13.2825374906591 +380000 ekin = 2.5346614309634 | erot = 2.75950320018496 | epot = -18.5767021221684 | etot = -13.28253749102 +381000 ekin = 2.50280930121805 | erot = 2.820545199185 | epot = -18.6058919915259 | etot = -13.2825374911229 +382000 ekin = 2.470812727732 | erot = 2.85587907291203 | epot = -18.6092292915694 | etot = -13.2825374909253 +383000 ekin = 2.44026108011508 | erot = 2.86702983654261 | epot = -18.5898284071357 | etot = -13.282537490478 +384000 ekin = 2.41324034479816 | erot = 2.85867137366513 | epot = -18.5544492083667 | etot = -13.2825374899034 +385000 ekin = 2.39197367794907 | erot = 2.83724859059171 | epot = -18.5117597578793 | etot = -13.2825374893386 +386000 ekin = 2.37848037079664 | erot = 2.80936838549805 | epot = -18.4703862451731 | etot = -13.2825374888784 +387000 ekin = 2.37440773877127 | erot = 2.78057799552109 | epot = -18.4375232228463 | etot = -13.282537488554 +388000 ekin = 2.38106033998957 | erot = 2.75482980994791 | epot = -18.4184276382837 | etot = -13.2825374883462 +389000 ekin = 2.39952694728403 | erot = 2.73455852134344 | epot = -18.4166229568446 | etot = -13.2825374882171 +390000 ekin = 2.43075796801616 | erot = 2.72108399954165 | epot = -18.4343794556986 | etot = -13.2825374881408 +391000 ekin = 2.47547758104241 | erot = 2.71503282253302 | epot = -18.4730478916951 | etot = -13.2825374881197 +392000 ekin = 2.53389941336453 | erot = 2.7165760791739 | epot = -18.5330129807221 | etot = -13.2825374881837 +393000 ekin = 2.60531467139695 | erot = 2.72543162367493 | epot = -18.6132837834427 | etot = -13.2825374883708 +394000 ekin = 2.68770614221252 | erot = 2.74072420161865 | epot = -18.7109678325333 | etot = -13.2825374887021 +395000 ekin = 2.77757589911151 | erot = 2.76089277951452 | epot = -18.8210061677825 | etot = -13.2825374891565 +396000 ekin = 2.87012638573488 | erot = 2.78383015196109 | epot = -18.9364940273617 | etot = -13.2825374896658 +397000 ekin = 2.95979968457167 | erot = 2.80730760068494 | epot = -19.049644775395 | etot = -13.2825374901384 +398000 ekin = 3.04101675292653 | erot = 2.82953067572568 | epot = -19.1530849191508 | etot = -13.2825374904986 +399000 ekin = 3.10335323688597 | erot = 2.84223393463616 | epot = -19.228124720834 | etot = -13.2825375493118 +400000 ekin = 3.10435999780448 | erot = 2.68059016645162 | epot = -19.0674876235106 | etot = -13.2825374592545 +401000 ekin = 3.39309095567053 | erot = 2.6399790010433 | epot = -19.3156074940173 | etot = -13.2825375373034 +402000 ekin = 3.44106634978254 | erot = 2.65979071672222 | epot = -19.3833945765536 | etot = -13.2825375100489 +403000 ekin = 3.43207406395648 | erot = 2.67998452071647 | epot = -19.3945960946571 | etot = -13.2825375099842 +404000 ekin = 3.40426891788004 | erot = 2.70237957197844 | epot = -19.3891859997704 | etot = -13.2825375099119 +405000 ekin = 3.35933473415418 | erot = 2.72607645469475 | epot = -19.3679486986676 | etot = -13.2825375098187 +406000 ekin = 3.29966540903968 | erot = 2.74995079996642 | epot = -19.3321537187046 | etot = -13.2825375096985 +407000 ekin = 3.22823117978945 | erot = 2.77286165528619 | epot = -19.2836303446341 | etot = -13.2825375095584 +408000 ekin = 3.1483591073605 | erot = 2.79373949031154 | epot = -19.2246361071148 | etot = -13.2825375094427 +409000 ekin = 3.06351542880808 | erot = 2.81131469887469 | epot = -19.1573676369864 | etot = -13.2825375093037 +410000 ekin = 2.97699949578463 | erot = 2.8246267920136 | epot = -19.0841637969997 | etot = -13.2825375092014 +411000 ekin = 2.89165449988321 | erot = 2.83289882079081 | epot = -19.007090829806 | etot = -13.282537509132 +412000 ekin = 2.80978906685915 | erot = 2.83549592234132 | epot = -18.9278224982724 | etot = -13.2825375090719 +413000 ekin = 2.73325536963672 | erot = 2.83215388790773 | epot = -18.8479467665295 | etot = -13.2825375089851 +414000 ekin = 2.66364879693787 | erot = 2.82325639295092 | epot = -18.7694426987271 | etot = -13.2825375088383 +415000 ekin = 2.60253860594386 | erot = 2.81004531903034 | epot = -18.6951214335909 | etot = -13.2825375086167 +416000 ekin = 2.55161661467894 | erot = 2.79464631188373 | epot = -18.6288004348987 | etot = -13.2825375083361 +417000 ekin = 2.51265407607916 | erot = 2.77984605492258 | epot = -18.5750376413351 | etot = -13.2825375103333 +418000 ekin = 2.4733460400696 | erot = 2.77799997552928 | epot = -18.5338835235814 | etot = -13.2825375079825 +419000 ekin = 2.44559608968299 | erot = 2.79655231011318 | epot = -18.5246859081161 | etot = -13.2825375083199 +420000 ekin = 2.44884495810883 | erot = 2.8127677686639 | epot = -18.5441502345376 | etot = -13.2825375077648 +421000 ekin = 2.47134322850907 | erot = 2.8275658566971 | epot = -18.581446593281 | etot = -13.2825375080748 +422000 ekin = 2.50522487691509 | erot = 2.84806830842189 | epot = -18.6358306938666 | etot = -13.2825375085297 +423000 ekin = 2.54673540362963 | erot = 2.87162843047139 | epot = -18.7009013431387 | etot = -13.2825375090377 +424000 ekin = 2.59155452677409 | erot = 2.89540834353099 | epot = -18.7695003797936 | etot = -13.2825375094885 +425000 ekin = 2.63549518710331 | erot = 2.91724946462186 | epot = -18.8352821615182 | etot = -13.282537509793 +426000 ekin = 2.67515430282142 | erot = 2.9363216769118 | epot = -18.8940134896421 | etot = -13.2825375099089 +427000 ekin = 2.70835356710237 | erot = 2.95332774897657 | epot = -18.9442188259222 | etot = -13.2825375098433 +428000 ekin = 2.73429370856415 | erot = 2.97029523904671 | epot = -18.9871264572452 | etot = -13.2825375096344 +429000 ekin = 2.75344687777166 | erot = 2.99015713230311 | epot = -19.0261415194056 | etot = -13.2825375093308 +430000 ekin = 2.76726512075389 | erot = 3.01631311482664 | epot = -19.0661157445654 | etot = -13.2825375089849 +431000 ekin = 2.77776520583174 | erot = 3.05220345438128 | epot = -19.1125061688761 | etot = -13.282537508663 +432000 ekin = 2.78700254671475 | erot = 3.10077153002521 | epot = -19.1703115851965 | etot = -13.2825375084566 +433000 ekin = 2.79644099945107 | erot = 3.16368547120708 | epot = -19.2426639791351 | etot = -13.2825375084769 +434000 ekin = 2.80629528100655 | erot = 3.24036053937453 | epot = -19.3291933292032 | etot = -13.2825375088222 +435000 ekin = 2.81503854861979 | erot = 3.32707633254736 | epot = -19.4246523906905 | etot = -13.2825375095233 +436000 ekin = 2.81936003427121 | erot = 3.41666372805949 | epot = -19.5185612728238 | etot = -13.2825375104931 +437000 ekin = 2.81480689570261 | erot = 3.4992068109881 | epot = -19.5965512182087 | etot = -13.282537511518 +438000 ekin = 2.79709037799446 | erot = 3.56380823491998 | epot = -19.6434361252458 | etot = -13.2825375123314 +439000 ekin = 2.76357573484127 | erot = 3.60097663046949 | epot = -19.6470898780263 | etot = -13.2825375127155 +440000 ekin = 2.71419714341147 | erot = 3.60475935377896 | epot = -19.6014940098203 | etot = -13.2825375126299 +441000 ekin = 2.65147586146302 | erot = 3.5735068280095 | epot = -19.5075202016404 | etot = -13.2825375121679 +442000 ekin = 2.57978868208042 | erot = 3.50949061111538 | epot = -19.3718168046633 | etot = -13.2825375114675 +443000 ekin = 2.5045655875428 | erot = 3.41786741963772 | epot = -19.2049705178136 | etot = -13.2825375106331 +444000 ekin = 2.4318529905012 | erot = 3.30558723791353 | epot = -19.0199777381389 | etot = -13.2825375097241 +445000 ekin = 2.36817510309247 | erot = 3.18052048206526 | epot = -18.8312330939434 | etot = -13.2825375087857 +446000 ekin = 2.32036350430697 | erot = 3.05081891042797 | epot = -18.6537199226 | etot = -13.2825375078651 +447000 ekin = 2.29507009388122 | erot = 2.92434156857507 | epot = -18.5019491695335 | etot = -13.2825375070773 +448000 ekin = 2.29792306266074 | erot = 2.80795199469404 | epot = -18.3884125638663 | etot = -13.2825375065115 +449000 ekin = 2.33256968728711 | erot = 2.7069587718276 | epot = -18.3220659653791 | etot = -13.2825375062644 +450000 ekin = 2.39980570006952 | erot = 2.62453468442755 | epot = -18.3068778908976 | etot = -13.2825375064006 +451000 ekin = 2.49706752601316 | erot = 2.56128240619122 | epot = -18.340887439138 | etot = -13.2825375069336 +452000 ekin = 2.61842576959522 | erot = 2.51510244033024 | epot = -18.4160657177069 | etot = -13.2825375077814 +453000 ekin = 2.75505822099767 | erot = 2.4815699152751 | epot = -18.5191656452272 | etot = -13.2825375089544 +454000 ekin = 2.89583245289786 | erot = 2.45420794645489 | epot = -18.6325779096516 | etot = -13.2825375102988 +455000 ekin = 3.02803920575135 | erot = 2.42568753015633 | epot = -18.7362642475679 | etot = -13.2825375116602 +456000 ekin = 3.13847091958599 | erot = 2.38932191986764 | epot = -18.8103303522241 | etot = -13.2825375127704 +457000 ekin = 3.21547363213364 | erot = 2.34093725375183 | epot = -18.838948399153 | etot = -13.2825375132675 +458000 ekin = 3.2519255084935 | erot = 2.28077893488055 | epot = -18.8152419562781 | etot = -13.282537512904 +459000 ekin = 3.24761130317629 | erot = 2.2142990448528 | epot = -18.7444478597993 | etot = -13.2825375117702 +460000 ekin = 3.20922400631774 | erot = 2.15086461862506 | epot = -18.6426261351955 | etot = -13.2825375102527 +461000 ekin = 3.14796311212567 | erot = 2.10092694609436 | epot = -18.5314275669974 | etot = -13.2825375087774 +462000 ekin = 3.07634336772018 | erot = 2.07329933809505 | epot = -18.4321802134275 | etot = -13.2825375076122 +463000 ekin = 3.00570913410551 | erot = 2.0736740452441 | epot = -18.3619206862057 | etot = -13.2825375068561 +464000 ekin = 2.94485829968431 | erot = 2.104311840005 | epot = -18.3317076462087 | etot = -13.2825375065194 +465000 ekin = 2.89946798282509 | erot = 2.16425406359513 | epot = -18.3462595530094 | etot = -13.2825375065892 +466000 ekin = 2.87195252748384 | erot = 2.24955307492882 | epot = -18.4040431094629 | etot = -13.2825375070502 +467000 ekin = 2.86158324929155 | erot = 2.35338924278566 | epot = -18.4975099999498 | etot = -13.2825375078726 +468000 ekin = 2.86493243611462 | erot = 2.46640127712313 | epot = -18.6138712220354 | etot = -13.2825375087976 +469000 ekin = 2.87700241085683 | erot = 2.57824581699685 | epot = -18.7377857379574 | etot = -13.2825375101037 +470000 ekin = 2.89115454215717 | erot = 2.6760619901597 | epot = -18.8497540436439 | etot = -13.2825375113271 +471000 ekin = 2.90087699699639 | erot = 2.74765202472445 | epot = -18.9310665339225 | etot = -13.2825375122017 +472000 ekin = 2.90129360657261 | erot = 2.78442288107442 | epot = -18.968254000156 | etot = -13.282537512509 +473000 ekin = 2.89014262488401 | erot = 2.78350866548211 | epot = -18.9561888025525 | etot = -13.2825375121863 +474000 ekin = 2.86798455519513 | erot = 2.74843722227868 | epot = -18.8989592888434 | etot = -13.2825375113696 +475000 ekin = 2.83751222123448 | erot = 2.68789202058937 | epot = -18.8079417521561 | etot = -13.2825375103323 +476000 ekin = 2.80225697256735 | erot = 2.6131130536835 | epot = -18.6979075356112 | etot = -13.2825375093603 +477000 ekin = 2.76525060538104 | erot = 2.5351054311932 | epot = -18.5828935452201 | etot = -13.2825375086459 +478000 ekin = 2.72814283270942 | erot = 2.46266477167759 | epot = -18.4733451126352 | etot = -13.2825375082482 +479000 ekin = 2.69099471856512 | erot = 2.40160392944764 | epot = -18.3751361561287 | etot = -13.282537508116 +480000 ekin = 2.65266810495577 | erot = 2.35496214915267 | epot = -18.2901677622972 | etot = -13.2825375081888 +481000 ekin = 2.61144235513308 | erot = 2.32364519373199 | epot = -18.2176250571285 | etot = -13.2825375082635 +482000 ekin = 2.56577673011677 | erot = 2.30767778315765 | epot = -18.1559920215987 | etot = -13.2825375083243 +483000 ekin = 2.51481850303814 | erot = 2.3066085334913 | epot = -18.1039645448551 | etot = -13.2825375083257 +484000 ekin = 2.4583813285785 | erot = 2.31984500682984 | epot = -18.0607638434006 | etot = -13.2825375079923 +485000 ekin = 2.37536403472682 | erot = 2.30798475217265 | epot = -17.9658863028417 | etot = -13.2825375159423 +486000 ekin = 2.31029787366189 | erot = 2.2748698765298 | epot = -17.8677052455195 | etot = -13.2825374953278 +487000 ekin = 2.35903895729104 | erot = 2.35840823836807 | epot = -17.999984715744 | etot = -13.2825375200849 +488000 ekin = 2.35207405530543 | erot = 2.45495770512307 | epot = -18.0895692764582 | etot = -13.2825375160297 +489000 ekin = 2.32025825392693 | erot = 2.54616767543756 | epot = -18.1489634454321 | etot = -13.2825375160676 +490000 ekin = 2.29515153865843 | erot = 2.64227715700559 | epot = -18.2199662119985 | etot = -13.2825375163345 +491000 ekin = 2.2772449984618 | erot = 2.73950547065074 | epot = -18.2992879857204 | etot = -13.2825375166078 +492000 ekin = 2.26670396933619 | erot = 2.83351832941017 | epot = -18.3827598156809 | etot = -13.2825375169346 +493000 ekin = 2.26314468313945 | erot = 2.91977614256862 | epot = -18.4654583429805 | etot = -13.2825375172724 +494000 ekin = 2.26577113860128 | erot = 2.99399214337922 | epot = -18.5423007995586 | etot = -13.2825375175781 +495000 ekin = 2.27355094490557 | erot = 3.05259857148999 | epot = -18.6086870342097 | etot = -13.2825375178141 +496000 ekin = 2.28538641730899 | erot = 3.09313022190335 | epot = -18.6610541571706 | etot = -13.2825375179582 +497000 ekin = 2.3002347482288 | erot = 3.1144407210763 | epot = -18.6972129873049 | etot = -13.2825375179998 +498000 ekin = 2.3171936593925 | erot = 3.11678508300488 | epot = -18.7165162603363 | etot = -13.2825375179389 +499000 ekin = 2.33554254161235 | erot = 3.10178716719771 | epot = -18.7198672265934 | etot = -13.2825375177834 +500000 ekin = 2.31317350059265 | erot = 3.05449093047628 | epot = -18.6502019677268 | etot = -13.2825375366579 +501000 ekin = 2.31231722972123 | erot = 3.00810318076113 | epot = -18.6029579372101 | etot = -13.2825375267278 +502000 ekin = 2.3899963895355 | erot = 2.98467042894116 | epot = -18.657204342111 | etot = -13.2825375236343 +503000 ekin = 2.41312387633379 | erot = 2.93091691357846 | epot = -18.6265783132594 | etot = -13.2825375233471 +504000 ekin = 2.43600229237452 | erot = 2.88130858481333 | epot = -18.5998484003212 | etot = -13.2825375231333 +505000 ekin = 2.45757791196529 | erot = 2.8401186666586 | epot = -18.5802341016713 | etot = -13.2825375230474 +506000 ekin = 2.47627134224398 | erot = 2.81025901806717 | epot = -18.5690678834509 | etot = -13.2825375231397 +507000 ekin = 2.48985246050699 | erot = 2.79268587932984 | epot = -18.5650758632795 | etot = -13.2825375234427 +508000 ekin = 2.49542483825493 | erot = 2.78597986937444 | epot = -18.5639422315766 | etot = -13.2825375239472 +509000 ekin = 2.48963204750428 | erot = 2.78630577995571 | epot = -18.5584753520407 | etot = -13.2825375245807 +510000 ekin = 2.4691743887688 | erot = 2.78796571282341 | epot = -18.5396776267959 | etot = -13.2825375252037 +511000 ekin = 2.43159454918128 | erot = 2.78459744696608 | epot = -18.4987295217946 | etot = -13.2825375256472 +512000 ekin = 2.37609227916261 | erot = 2.77073697944887 | epot = -18.4293667843926 | etot = -13.2825375257811 +513000 ekin = 2.30402039322225 | erot = 2.74317280237148 | epot = -18.3297307211636 | etot = -13.2825375255699 +514000 ekin = 2.21884081242786 | erot = 2.7015541486614 | epot = -18.2029324861651 | etot = -13.2825375250758 +515000 ekin = 2.12561338171218 | erot = 2.64810551843191 | epot = -18.056256424559 | etot = -13.2825375244149 +516000 ekin = 2.03029958566718 | erot = 2.58673985991495 | epot = -17.8995769692823 | etot = -13.2825375237002 +517000 ekin = 1.93914577197132 | erot = 2.5220605431355 | epot = -17.7437438381168 | etot = -13.28253752301 +518000 ekin = 1.85826662413893 | erot = 2.45858700715527 | epot = -17.5993911536849 | etot = -13.2825375223908 +519000 ekin = 1.79333215326611 | erot = 2.40035341708905 | epot = -17.476223092216 | etot = -13.2825375218608 +520000 ekin = 1.74929005171215 | erot = 2.35078235677519 | epot = -17.3826099299227 | etot = -13.2825375214353 +521000 ekin = 1.73007209347361 | erot = 2.31266171841647 | epot = -17.3252713330271 | etot = -13.282537521137 +522000 ekin = 1.73822781685003 | erot = 2.28811557190088 | epot = -17.3088809097447 | etot = -13.2825375209937 +523000 ekin = 1.77456624775216 | erot = 2.27850834583591 | epot = -17.3356121146208 | etot = -13.2825375210327 +524000 ekin = 1.8379045851724 | erot = 2.28429322274985 | epot = -17.4047353291923 | etot = -13.28253752127 +525000 ekin = 1.92500868751529 | erot = 2.30484700359158 | epot = -17.5123932128129 | etot = -13.282537521706 +526000 ekin = 2.03075780261764 | erot = 2.33833465322237 | epot = -17.6516299781653 | etot = -13.2825375223253 +527000 ekin = 2.14850843909257 | erot = 2.38164040104111 | epot = -17.8126863632292 | etot = -13.2825375230955 +528000 ekin = 2.2706009665318 | erot = 2.43041424714547 | epot = -17.9835527376429 | etot = -13.2825375239656 +529000 ekin = 2.38896012867467 | erot = 2.47931387509597 | epot = -18.150811528629 | etot = -13.2825375248584 +530000 ekin = 2.4957694053979 | erot = 2.52254117019752 | epot = -18.3008481012612 | etot = -13.2825375256658 +531000 ekin = 2.58420744224834 | erot = 2.55472238423688 | epot = -18.4214673527446 | etot = -13.2825375262593 +532000 ekin = 2.64918587021021 | erot = 2.57201883159204 | epot = -18.5037422283274 | etot = -13.2825375265252 +533000 ekin = 2.68793333158334 | erot = 2.57313230806675 | epot = -18.5436031660632 | etot = -13.2825375264131 +534000 ekin = 2.7002120821811 | erot = 2.55975253143246 | epot = -18.5425021395846 | etot = -13.2825375259711 +535000 ekin = 2.68802701636055 | erot = 2.5361501485681 | epot = -18.5067146902622 | etot = -13.2825375253335 +536000 ekin = 2.65489019113613 | erot = 2.50801671119336 | epot = -18.4454444269979 | etot = -13.2825375246684 +537000 ekin = 2.60490332064252 | erot = 2.481023337825 | epot = -18.3684641825809 | etot = -13.2825375241133 +538000 ekin = 2.54198784535114 | erot = 2.45965628954573 | epot = -18.2841816578421 | etot = -13.2825375229452 +539000 ekin = 2.47150013363699 | erot = 2.44756195577151 | epot = -18.2015996123808 | etot = -13.2825375229723 +540000 ekin = 2.39647534123056 | erot = 2.44525435897827 | epot = -18.124267223265 | etot = -13.2825375230561 +541000 ekin = 2.31786635163547 | erot = 2.45130088246703 | epot = -18.0517047572224 | etot = -13.2825375231199 +542000 ekin = 2.23702678127242 | erot = 2.46423888155736 | epot = -17.9838031859226 | etot = -13.2825375230928 +543000 ekin = 2.15612181944835 | erot = 2.4831366740889 | epot = -17.9217960164714 | etot = -13.2825375229342 +544000 ekin = 2.07836492813028 | erot = 2.50789688702757 | epot = -17.8687993378082 | etot = -13.2825375226504 +545000 ekin = 2.0079425836599 | erot = 2.5391884088184 | epot = -17.8296685147796 | etot = -13.2825375223013 +546000 ekin = 1.94957099406152 | erot = 2.57800819606447 | epot = -17.8101167121046 | etot = -13.2825375219786 +547000 ekin = 1.90776242425117 | erot = 2.62501532095444 | epot = -17.8153152669927 | etot = -13.2825375217871 +548000 ekin = 1.88600984704774 | erot = 2.67988146407457 | epot = -17.8484288329186 | etot = -13.2825375217963 +549000 ekin = 1.88615242684612 | erot = 2.7409037562111 | epot = -17.90959370508 | etot = -13.2825375220228 +550000 ekin = 1.90811801075785 | erot = 2.80501593008068 | epot = -17.9956714632668 | etot = -13.2825375224283 +551000 ekin = 1.95008337619707 | erot = 2.8681680442257 | epot = -18.1007889433631 | etot = -13.2825375229403 +552000 ekin = 2.00893649348012 | erot = 2.92590890431006 | epot = -18.2173829212704 | etot = -13.2825375234803 +553000 ekin = 2.08084803908336 | erot = 2.97396311014114 | epot = -18.3373486732109 | etot = -13.2825375239864 +554000 ekin = 2.16178844740114 | erot = 3.00865361320263 | epot = -18.452979585024 | etot = -13.2825375244202 +555000 ekin = 2.24792031028555 | erot = 3.02713377655537 | epot = -18.5575916115995 | etot = -13.2825375247586 +556000 ekin = 2.3358895304513 | erot = 3.02749801452678 | epot = -18.6459250699588 | etot = -13.2825375249808 +557000 ekin = 2.42273135016537 | erot = 3.0079937814166 | epot = -18.7132626569264 | etot = -13.2825375253445 +558000 ekin = 2.50467530617043 | erot = 2.96457109815147 | epot = -18.7517839296998 | etot = -13.2825375253779 +559000 ekin = 2.57989829545908 | erot = 2.89795083555213 | epot = -18.7603866561733 | etot = -13.2825375251621 +560000 ekin = 2.64819333039288 | erot = 2.81150114191978 | epot = -18.742231997059 | etot = -13.2825375247463 +561000 ekin = 2.7104101471449 | erot = 2.71050571098959 | epot = -18.7034533823758 | etot = -13.2825375242413 +562000 ekin = 2.76764108182985 | erot = 2.60142670489701 | epot = -18.6516053104994 | etot = -13.2825375237726 +563000 ekin = 2.8204133217691 | erot = 2.4909454000306 | epot = -18.5938962452166 | etot = -13.2825375234169 +564000 ekin = 2.86835957175242 | erot = 2.38512022714126 | epot = -18.536017322071 | etot = -13.2825375231773 +565000 ekin = 2.91050556249757 | erot = 2.28886993106156 | epot = -18.481913016576 | etot = -13.2825375230169 +566000 ekin = 2.94583619535282 | erot = 2.20572382115438 | epot = -18.4340975394231 | etot = -13.2825375229159 +567000 ekin = 2.97364576055568 | erot = 2.13764971286302 | epot = -18.3938329963098 | etot = -13.2825375228911 +568000 ekin = 2.99348659090309 | erot = 2.08490808296841 | epot = -18.360932196845 | etot = -13.2825375229735 +569000 ekin = 3.00487691646457 | erot = 2.04604350397463 | epot = -18.3334579436043 | etot = -13.2825375231651 +570000 ekin = 3.00710556181106 | erot = 2.01819764944608 | epot = -18.3078407346813 | etot = -13.2825375234241 +571000 ekin = 2.99930468666728 | erot = 1.99774357921139 | epot = -18.2795857895585 | etot = -13.2825375236798 +572000 ekin = 2.98076231237764 | erot = 1.98107714037278 | epot = -18.2443769766043 | etot = -13.2825375238539 +573000 ekin = 2.95134611354571 | erot = 1.96535938859269 | epot = -18.1992430260208 | etot = -13.2825375238824 +574000 ekin = 2.91190615156914 | erot = 1.94906161393782 | epot = -18.1435052892334 | etot = -13.2825375237264 +575000 ekin = 2.86455063783071 | erot = 1.93223482559859 | epot = -18.079322986811 | etot = -13.2825375233817 +576000 ekin = 2.81270724054619 | erot = 1.91646454104923 | epot = -18.0117093044799 | etot = -13.2825375228844 +577000 ekin = 2.76090536128439 | erot = 1.9045038205141 | epot = -17.9479467041077 | etot = -13.2825375223092 +578000 ekin = 2.71428886858076 | erot = 1.89991544416371 | epot = -17.8967418344083 | etot = -13.2825375216638 +579000 ekin = 2.67747364109253 | erot = 1.90598531718256 | epot = -17.8659964795852 | etot = -13.2825375213101 +580000 ekin = 2.65399321096934 | erot = 1.92422800253644 | epot = -17.8607587346238 | etot = -13.282537521118 +581000 ekin = 2.64614770784911 | erot = 1.95489680824256 | epot = -17.883582037231 | etot = -13.2825375211393 +582000 ekin = 2.65445309232027 | erot = 1.99685469220196 | epot = -17.9338453059165 | etot = -13.2825375213943 +583000 ekin = 2.67733631605306 | erot = 2.04763712313085 | epot = -18.0075109610395 | etot = -13.2825375218556 +584000 ekin = 2.71054840601244 | erot = 2.10372916960457 | epot = -18.0968150982853 | etot = -13.2825375226683 +585000 ekin = 2.74737763681928 | erot = 2.16073411835811 | epot = -18.1906492785603 | etot = -13.282537523383 +586000 ekin = 2.7813786998355 | erot = 2.21419390100359 | epot = -18.2781101248089 | etot = -13.2825375239698 +587000 ekin = 2.80697388603962 | erot = 2.26053952382245 | epot = -18.3500509341984 | etot = -13.2825375243363 +588000 ekin = 2.82026432869703 | erot = 2.29760845660022 | epot = -18.4004103097634 | etot = -13.2825375244661 +589000 ekin = 2.81926713936076 | erot = 2.32471340247167 | epot = -18.4265180662398 | etot = -13.2825375244073 +590000 ekin = 2.80363912211435 | erot = 2.34232144628174 | epot = -18.4284980926317 | etot = -13.2825375242356 +591000 ekin = 2.77414618244973 | erot = 2.35158565792353 | epot = -18.4082693643883 | etot = -13.282537524015 +592000 ekin = 2.73214162068033 | erot = 2.35397672704535 | epot = -18.3686558715069 | etot = -13.2825375237812 +593000 ekin = 2.67919893301821 | erot = 2.35111989741865 | epot = -18.3128563539823 | etot = -13.2825375235455 +594000 ekin = 2.61691997575019 | erot = 2.34478637079319 | epot = -18.2442438698508 | etot = -13.2825375233074 +595000 ekin = 2.54687226698967 | erot = 2.33692048100541 | epot = -18.1663302710608 | etot = -13.2825375230657 +596000 ekin = 2.47060065847364 | erot = 2.32961421031687 | epot = -18.0827523916134 | etot = -13.2825375228228 +597000 ekin = 2.38967001316585 | erot = 2.32500896595718 | epot = -17.9972165017067 | etot = -13.2825375225837 +598000 ekin = 2.30571268082223 | erot = 2.32515834060408 | epot = -17.9134085437803 | etot = -13.282537522354 +599000 ekin = 2.22046028550116 | erot = 2.33189649118178 | epot = -17.8348942988225 | etot = -13.2825375221395 +600000 ekin = 2.13574370490705 | erot = 2.34673734057022 | epot = -17.7650185674242 | etot = -13.2825375219469 +601000 ekin = 2.05345123937653 | erot = 2.37080533030337 | epot = -17.7067940914646 | etot = -13.2825375217847 +602000 ekin = 1.97544542053429 | erot = 2.40478648031343 | epot = -17.6627694225103 | etot = -13.2825375216626 +603000 ekin = 1.9034510520118 | erot = 2.44889273156788 | epot = -17.6348813051703 | etot = -13.2825375215906 +604000 ekin = 1.83893895945378 | erot = 2.50284547570514 | epot = -17.6243219567308 | etot = -13.2825375215719 +605000 ekin = 1.78304137655287 | erot = 2.56590806869957 | epot = -17.6314869668566 | etot = -13.2825375216041 +606000 ekin = 1.736517005622 | erot = 2.63697396084372 | epot = -17.6560284881414 | etot = -13.2825375216757 +607000 ekin = 1.69978182226254 | erot = 2.71471645486191 | epot = -17.6970357988931 | etot = -13.2825375217686 +608000 ekin = 1.67299629743623 | erot = 2.79777529958915 | epot = -17.7533091188892 | etot = -13.2825375218638 +609000 ekin = 1.65617951190665 | erot = 2.88492902630375 | epot = -17.8236460601579 | etot = -13.2825375219475 +610000 ekin = 1.64931072740771 | erot = 2.97519912008037 | epot = -17.9070473695038 | etot = -13.2825375220157 +611000 ekin = 1.65238727025306 | erot = 3.06785620899647 | epot = -18.0027810013235 | etot = -13.2825375220739 +612000 ekin = 1.66542824834998 | erot = 3.16233835695483 | epot = -18.1103041274379 | etot = -13.2825375221331 +613000 ekin = 1.68843555860806 | erot = 3.25812385028217 | epot = -18.229096931095 | etot = -13.2825375222048 +614000 ekin = 1.72133601882631 | erot = 3.35460405562833 | epot = -18.3584775967531 | etot = -13.2825375222984 +615000 ekin = 1.76392386055006 | erot = 3.45098117167973 | epot = -18.4974425546512 | etot = -13.2825375224214 +616000 ekin = 1.81580855352879 | erot = 3.54618284211553 | epot = -18.6445289182269 | etot = -13.2825375225826 +617000 ekin = 1.87635766444892 | erot = 3.63876572292309 | epot = -18.7976609101672 | etot = -13.2825375227952 +618000 ekin = 1.94461656663335 | erot = 3.72678561706335 | epot = -18.9539397067739 | etot = -13.2825375230772 +619000 ekin = 2.01919440946448 | erot = 3.80764383017264 | epot = -19.1093757630845 | etot = -13.2825375234473 +620000 ekin = 2.09812821732459 | erot = 3.87796751089518 | epot = -19.258633252134 | etot = -13.2825375239142 +621000 ekin = 2.17876896452369 | erot = 3.9336243470245 | epot = -19.3949308360123 | etot = -13.2825375244641 +622000 ekin = 2.25776112944306 | erot = 3.96997899371136 | epot = -19.5102776482054 | etot = -13.282537525051 +623000 ekin = 2.33118920319666 | erot = 3.98244070312544 | epot = -19.5961674319216 | etot = -13.2825375255995 +624000 ekin = 2.39492361710553 | erot = 3.96722578269959 | epot = -19.6446869258275 | etot = -13.2825375260223 +625000 ekin = 2.445122210933 | erot = 3.92212025382369 | epot = -19.6497799910047 | etot = -13.282537526248 +626000 ekin = 2.47876984838125 | erot = 3.84697362716387 | epot = -19.6082810017884 | etot = -13.2825375262432 +627000 ekin = 2.49411681790099 | erot = 3.74375083248538 | epot = -19.5204051764041 | etot = -13.2825375260178 +628000 ekin = 2.49092177716844 | erot = 3.61617309043397 | epot = -19.3896323932121 | etot = -13.2825375256096 +629000 ekin = 2.47048208783205 | erot = 3.46915451631132 | epot = -19.2221741292085 | etot = -13.2825375250651 +630000 ekin = 2.43548970061162 | erot = 3.30827690351569 | epot = -19.0263041285523 | etot = -13.282537524425 +631000 ekin = 2.38975948996613 | erot = 3.13944249320995 | epot = -18.8117395069008 | etot = -13.2825375237248 +632000 ekin = 2.33785618698542 | erot = 2.96869689909723 | epot = -18.5890906090837 | etot = -13.2825375230011 +633000 ekin = 2.28462964544115 | erot = 2.80211551086663 | epot = -18.3692826786082 | etot = -13.2825375223005 +634000 ekin = 2.23467746223165 | erot = 2.64563252187923 | epot = -18.1628475057907 | etot = -13.2825375216799 +635000 ekin = 2.15322765543132 | erot = 2.47835094336846 | epot = -17.9141161495184 | etot = -13.2825375507186 +636000 ekin = 2.04549908133069 | erot = 2.31412508405115 | epot = -17.6421616868109 | etot = -13.2825375214291 +637000 ekin = 2.11104805175097 | erot = 2.29419960731515 | epot = -17.6877852052413 | etot = -13.2825375461752 +638000 ekin = 2.16990019917156 | erot = 2.2679567393031 | epot = -17.7203944764658 | etot = -13.2825375379911 +639000 ekin = 2.15825321743296 | erot = 2.17815663923705 | epot = -17.618947382456 | etot = -13.282537525786 +640000 ekin = 2.18911467644369 | erot = 2.15600946831685 | epot = -17.627661668769 | etot = -13.2825375240084 +641000 ekin = 2.26653815123457 | erot = 2.22106973674797 | epot = -17.7701454241734 | etot = -13.2825375361909 +642000 ekin = 2.3144469471055 | erot = 2.28426426145084 | epot = -17.8812487361676 | etot = -13.2825375276113 +643000 ekin = 2.32966846054207 | erot = 2.32625113868682 | epot = -17.9384571273534 | etot = -13.2825375281245 +644000 ekin = 2.33971908606118 | erot = 2.36941556717976 | epot = -17.9916721817351 | etot = -13.2825375284942 +645000 ekin = 2.34497836839587 | erot = 2.40804261253567 | epot = -18.0355585095904 | etot = -13.2825375286589 +646000 ekin = 2.34716147917123 | erot = 2.43809135045114 | epot = -18.0677903582286 | etot = -13.2825375286062 +647000 ekin = 2.34901351981608 | erot = 2.45765540472021 | epot = -18.0892064529145 | etot = -13.2825375283782 +648000 ekin = 2.35429037962735 | erot = 2.46814608869922 | epot = -18.104973996447 | etot = -13.2825375281204 +649000 ekin = 2.36637490476275 | erot = 2.47306901795835 | epot = -18.1219814507637 | etot = -13.2825375280426 +650000 ekin = 2.38594651024424 | erot = 2.47280388235694 | epot = -18.1412879205825 | etot = -13.2825375279813 +651000 ekin = 2.41290732393566 | erot = 2.46797500557286 | epot = -18.1634198574497 | etot = -13.2825375279412 +652000 ekin = 2.44657292409709 | erot = 2.45942209570518 | epot = -18.1885325477104 | etot = -13.2825375279081 +653000 ekin = 2.48591189131261 | erot = 2.44818643125859 | epot = -18.216635850432 | etot = -13.2825375278608 +654000 ekin = 2.52980786353021 | erot = 2.43558904352257 | epot = -18.2479344348361 | etot = -13.2825375277833 +655000 ekin = 2.57725720746836 | erot = 2.42329690336763 | epot = -18.2830916385098 | etot = -13.2825375276738 +656000 ekin = 2.62745567870598 | erot = 2.41329334491405 | epot = -18.3232865511668 | etot = -13.2825375275468 +657000 ekin = 2.67977157736399 | erot = 2.40771681185305 | epot = -18.3700259166474 | etot = -13.2825375274304 +658000 ekin = 2.73363379229086 | erot = 2.40858022061921 | epot = -18.4247515402698 | etot = -13.2825375273597 +659000 ekin = 2.78837854459658 | erot = 2.41741767328155 | epot = -18.4883337452466 | etot = -13.2825375273685 +660000 ekin = 2.84314536322858 | erot = 2.43497153591091 | epot = -18.5606544265713 | etot = -13.2825375274319 +661000 ekin = 2.89550751715279 | erot = 2.46002725149102 | epot = -18.6380722967303 | etot = -13.2825375280865 +662000 ekin = 2.93874528646413 | erot = 2.48685588461621 | epot = -18.708138699778 | etot = -13.2825375286977 +663000 ekin = 2.9687171942415 | erot = 2.51022783071497 | epot = -18.7614825541983 | etot = -13.2825375292419 +664000 ekin = 2.98246138427311 | erot = 2.52516926734448 | epot = -18.7901681812018 | etot = -13.2825375295842 +665000 ekin = 2.97884445494023 | erot = 2.52787955705445 | epot = -18.7892615416123 | etot = -13.2825375296177 +666000 ekin = 2.95920183353605 | erot = 2.51661508434599 | epot = -18.7583544471906 | etot = -13.2825375293085 +667000 ekin = 2.92742550356365 | erot = 2.49210329858316 | epot = -18.702066330864 | etot = -13.2825375287172 +668000 ekin = 2.88934250717656 | erot = 2.45736670750009 | epot = -18.6292467426517 | etot = -13.282537527975 +669000 ekin = 2.85155010044156 | erot = 2.41708074176435 | epot = -18.5511683694359 | etot = -13.28253752723 +670000 ekin = 2.82014314471955 | erot = 2.37673699551223 | epot = -18.4794176668284 | etot = -13.2825375265966 +671000 ekin = 2.79977472961205 | erot = 2.34183940273354 | epot = -18.4241516586146 | etot = -13.282537526269 +672000 ekin = 2.79293252634008 | erot = 2.31695226011576 | epot = -18.3924223124527 | etot = -13.2825375259969 +673000 ekin = 2.80034442408037 | erot = 2.30554472206325 | epot = -18.3884266720798 | etot = -13.2825375259361 +674000 ekin = 2.82129825256449 | erot = 2.30955451981648 | epot = -18.4133902984753 | etot = -13.2825375260944 +675000 ekin = 2.85361934145821 | erot = 2.32878748968739 | epot = -18.4649443576069 | etot = -13.2825375264613 +676000 ekin = 2.89394924995267 | erot = 2.36084337707399 | epot = -18.5373301540152 | etot = -13.2825375269885 +677000 ekin = 2.93819888436731 | erot = 2.40146056805032 | epot = -18.622196980004 | etot = -13.2825375275863 +678000 ekin = 2.98219881046511 | erot = 2.44527797789796 | epot = -18.7100143165049 | etot = -13.2825375281419 +679000 ekin = 3.0224273551935 | erot = 2.48684948025749 | epot = -18.7918143640021 | etot = -13.2825375285511 +680000 ekin = 3.05660821680256 | erot = 2.52163649378434 | epot = -18.8607822393395 | etot = -13.2825375287526 +681000 ekin = 3.08399348184627 | erot = 2.54671087858252 | epot = -18.913241889164 | etot = -13.2825375287352 +682000 ekin = 3.10527370304788 | erot = 2.56103519408599 | epot = -18.9488464256748 | etot = -13.2825375285409 +683000 ekin = 3.12217420783238 | erot = 2.56530128681684 | epot = -18.970013022889 | etot = -13.2825375282398 +684000 ekin = 3.13689854376774 | erot = 2.56147023258304 | epot = -18.9809063042598 | etot = -13.282537527909 +685000 ekin = 3.1516175207619 | erot = 2.55220833199615 | epot = -18.9863633803528 | etot = -13.2825375275947 +686000 ekin = 3.16825656288024 | erot = 2.5404714195813 | epot = -18.9912655098718 | etot = -13.2825375274103 +687000 ekin = 3.18756268898112 | erot = 2.52861508568613 | epot = -18.9987153019925 | etot = -13.2825375273252 +688000 ekin = 3.20935294724633 | erot = 2.51834078646032 | epot = -19.0102312610592 | etot = -13.2825375273526 +689000 ekin = 3.232603857627 | erot = 2.51058529363817 | epot = -19.0257266787599 | etot = -13.2825375274947 +690000 ekin = 3.25550449412986 | erot = 2.50541094760363 | epot = -19.0434529694767 | etot = -13.2825375277432 +691000 ekin = 3.27559454461619 | erot = 2.50196131507165 | epot = -19.0600933877637 | etot = -13.2825375280759 +692000 ekin = 3.29000453529088 | erot = 2.49851988079962 | epot = -19.0710619445408 | etot = -13.2825375284503 +693000 ekin = 3.29579865376218 | erot = 2.49273974858803 | epot = -19.0710759311567 | etot = -13.2825375288065 +694000 ekin = 3.29036742009323 | erot = 2.48207188557003 | epot = -19.0549768347445 | etot = -13.2825375290813 +695000 ekin = 3.27176421105106 | erot = 2.46431581831664 | epot = -19.018617558596 | etot = -13.2825375292283 +696000 ekin = 3.23887890273548 | erot = 2.43812365834886 | epot = -18.9595400903186 | etot = -13.2825375292342 +697000 ekin = 3.19141377377666 | erot = 2.40329594550704 | epot = -18.8772472483983 | etot = -13.2825375291146 +698000 ekin = 3.12971664175668 | erot = 2.36079934043281 | epot = -18.7730535110947 | etot = -13.2825375289052 +699000 ekin = 3.05458980626054 | erot = 2.31258576039904 | epot = -18.6497130952911 | etot = -13.2825375286315 +700000 ekin = 2.96718102298747 | erot = 2.26139197208619 | epot = -18.511110523382 | etot = -13.2825375283083 +701000 ekin = 2.86896613295136 | erot = 2.21057215459575 | epot = -18.3620758154883 | etot = -13.2825375279412 +702000 ekin = 2.76178671337415 | erot = 2.16397434352371 | epot = -18.2082985844344 | etot = -13.2825375275365 +703000 ekin = 2.6478712031048 | erot = 2.12574771744291 | epot = -18.0561564515416 | etot = -13.2825375309939 +704000 ekin = 2.52933762848166 | erot = 2.08674637122766 | epot = -17.8986215283831 | etot = -13.2825375286737 +705000 ekin = 2.41679696536635 | erot = 2.05664012325241 | epot = -17.7559746148874 | etot = -13.2825375262686 +706000 ekin = 2.30501007356423 | erot = 2.0611587655127 | epot = -17.6487063635301 | etot = -13.2825375244532 +707000 ekin = 2.19269241365679 | erot = 2.113750463821 | epot = -17.5889804021149 | etot = -13.2825375246371 +708000 ekin = 2.09960598348176 | erot = 2.19681319891601 | epot = -17.57895670939 | etot = -13.2825375269922 +709000 ekin = 2.01320280623464 | erot = 2.28016876647 | epot = -17.5759090980898 | etot = -13.2825375253852 +710000 ekin = 1.93302644427356 | erot = 2.37473228784994 | epot = -17.5902962580752 | etot = -13.2825375259517 +711000 ekin = 1.85957279067715 | erot = 2.47358324929754 | epot = -17.6156935666084 | etot = -13.2825375266337 +712000 ekin = 1.79282630268912 | erot = 2.56690430142539 | epot = -17.642268131402 | etot = -13.2825375272875 +713000 ekin = 1.73341814876089 | erot = 2.64462400340569 | epot = -17.6605796799123 | etot = -13.2825375277457 +714000 ekin = 1.68328438252143 | erot = 2.69817364688335 | epot = -17.6639955572831 | etot = -13.2825375278783 +715000 ekin = 1.64594117648568 | erot = 2.72207244107394 | epot = -17.6505511452113 | etot = -13.2825375276517 +716000 ekin = 1.62610172701181 | erot = 2.71479815151566 | epot = -17.6234374056764 | etot = -13.282537527149 +717000 ekin = 1.62864489627545 | erot = 2.67867233618631 | epot = -17.589854758993 | etot = -13.2825375265313 +718000 ekin = 1.65730138310094 | erot = 2.6189183926284 | epot = -17.5587573016927 | etot = -13.2825375259634 +719000 ekin = 1.71360335058015 | erot = 2.54235654223589 | epot = -17.5384974183669 | etot = -13.2825375255509 +720000 ekin = 1.79650653909672 | erot = 2.45621436685583 | epot = -17.5352584312718 | etot = -13.2825375253192 +721000 ekin = 1.90273489852489 | erot = 2.36731439641998 | epot = -17.5525868201814 | etot = -13.2825375252366 +722000 ekin = 2.02756635877135 | erot = 2.28163864595547 | epot = -17.5917425299821 | etot = -13.2825375252553 +723000 ekin = 2.16566245424335 | erot = 2.20411346294851 | epot = -17.6523134425365 | etot = -13.2825375253446 +724000 ekin = 2.31164907977026 | erot = 2.13844446404667 | epot = -17.7326310693194 | etot = -13.2825375255025 +725000 ekin = 2.46036017286876 | erot = 2.0869120441014 | epot = -17.8298097427178 | etot = -13.2825375257477 +726000 ekin = 2.60683496355671 | erot = 2.05013619406281 | epot = -17.9395086837224 | etot = -13.2825375261029 +727000 ekin = 2.74622028398704 | erot = 2.02690424050256 | epot = -18.0556620510616 | etot = -13.282537526572 +728000 ekin = 2.87374866259628 | erot = 2.01419303066656 | epot = -18.1704792203877 | etot = -13.2825375271249 +729000 ekin = 2.98490085178579 | erot = 2.00751009694371 | epot = -18.27494847642 | etot = -13.2825375276905 +730000 ekin = 3.07576690667731 | erot = 2.00160558070566 | epot = -18.359910015553 | etot = -13.28253752817 +731000 ekin = 3.14351022574244 | erot = 1.99146923020489 | epot = -18.4175169844133 | etot = -13.282537528466 +732000 ekin = 3.18676307284264 | erot = 1.97337750697634 | epot = -18.4426781083327 | etot = -13.2825375285137 +733000 ekin = 3.20579220152253 | erot = 1.9456870659553 | epot = -18.4340167957808 | etot = -13.282537528303 +734000 ekin = 3.20238921812918 | erot = 1.90917251422492 | epot = -18.3940992602234 | etot = -13.2825375278693 +735000 ekin = 3.17951096479738 | erot = 1.86680153237891 | epot = -18.3288500244819 | etot = -13.2825375273056 +736000 ekin = 3.14073865389039 | erot = 1.8230058759971 | epot = -18.2462820565793 | etot = -13.2825375266918 +737000 ekin = 3.08984658437012 | erot = 1.78292393032115 | epot = -18.1553080407961 | etot = -13.2825375261048 +738000 ekin = 3.03043228101277 | erot = 1.75161934959083 | epot = -18.0645891562027 | etot = -13.2825375255991 +739000 ekin = 2.96566842757407 | erot = 1.73346651117868 | epot = -17.9816724639599 | etot = -13.2825375252071 +740000 ekin = 2.89817088986259 | erot = 1.73175552877345 | epot = -17.912463943576 | etot = -13.28253752494 +741000 ekin = 2.82995232211993 | erot = 1.74850528634245 | epot = -17.8609951332633 | etot = -13.282537524801 +742000 ekin = 2.76247533972923 | erot = 1.78434362386512 | epot = -17.8293564883915 | etot = -13.2825375247972 +743000 ekin = 2.69668176519633 | erot = 1.83847103681881 | epot = -17.8176903269097 | etot = -13.2825375248946 +744000 ekin = 2.6331144461464 | erot = 1.90875045568272 | epot = -17.8244024269328 | etot = -13.2825375251037 +745000 ekin = 2.5719649351672 | erot = 1.99171779991018 | epot = -17.8462202604955 | etot = -13.2825375254181 +746000 ekin = 2.51311596152491 | erot = 2.0826421561814 | epot = -17.8782956435303 | etot = -13.282537525824 +747000 ekin = 2.45621024026481 | erot = 2.17571767245968 | epot = -17.9144654390156 | etot = -13.2825375262911 +748000 ekin = 2.4007641204603 | erot = 2.26445242853415 | epot = -17.9477540757611 | etot = -13.2825375267666 +749000 ekin = 2.34635697390621 | erot = 2.34231237598165 | epot = -17.9712068770626 | etot = -13.2825375271748 +750000 ekin = 2.29290375451926 | erot = 2.40359513867759 | epot = -17.9790364206262 | etot = -13.2825375274293 +751000 ekin = 2.24097207239074 | erot = 2.44437862835496 | epot = -17.9678882282051 | etot = -13.2825375274594 +752000 ekin = 2.19206377659927 | erot = 2.46328788147024 | epot = -17.9378891852944 | etot = -13.2825375272249 +753000 ekin = 2.01910736680425 | erot = 2.37844688257153 | epot = -17.6800917192355 | etot = -13.2825374698597 +754000 ekin = 2.03397419758721 | erot = 2.38379927539831 | epot = -17.7003109699574 | etot = -13.2825374969719 +755000 ekin = 2.10287082583243 | erot = 2.42269050537392 | epot = -17.808098775342 | etot = -13.2825374441357 +756000 ekin = 2.09556625459035 | erot = 2.40575096267731 | epot = -17.7838546607744 | etot = -13.2825374435067 +757000 ekin = 2.11013463605079 | erot = 2.39174642208689 | epot = -17.7844185011481 | etot = -13.2825374430104 +758000 ekin = 2.14991880608121 | erot = 2.38537981475823 | epot = -17.8178360635602 | etot = -13.2825374427207 +759000 ekin = 2.21691275096553 | erot = 2.38948785856312 | epot = -17.8889380522097 | etot = -13.2825374426811 +760000 ekin = 2.31141054899228 | erot = 2.40468264922822 | epot = -17.9986306411391 | etot = -13.2825374429186 +761000 ekin = 2.43175472397619 | erot = 2.42917556867249 | epot = -18.1434677360907 | etot = -13.282537443442 +762000 ekin = 2.57423243283704 | erot = 2.45878794779634 | epot = -18.3155578248644 | etot = -13.2825374442311 +763000 ekin = 2.73317609373997 | erot = 2.48721280702134 | epot = -18.5029263459876 | etot = -13.2825374452263 +764000 ekin = 2.90131643326679 | erot = 2.50663479900723 | epot = -18.690488678594 | etot = -13.28253744632 +765000 ekin = 3.07040159566699 | erot = 2.50879317366612 | epot = -18.8617322166939 | etot = -13.2825374473608 +766000 ekin = 3.23203071048149 | erot = 2.48644536532744 | epot = -19.0010135239876 | etot = -13.2825374481786 +767000 ekin = 3.37856609507255 | erot = 2.43498273995184 | epot = -19.0960862836549 | etot = -13.2825374486305 +768000 ekin = 3.50392633330507 | erot = 2.35374465383522 | epot = -19.1402084357865 | etot = -13.2825374486462 +769000 ekin = 3.60408080015212 | erot = 2.24656658386371 | epot = -19.1331848322651 | etot = -13.2825374482493 +770000 ekin = 3.67731902122504 | erot = 2.12129309978206 | epot = -19.0811495685446 | etot = -13.2825374475374 +771000 ekin = 3.72500466537174 | erot = 1.98803922980452 | epot = -18.9955813418785 | etot = -13.2825374467023 +772000 ekin = 3.73784328897891 | erot = 1.84847100615872 | epot = -18.8688517432933 | etot = -13.2825374481557 +773000 ekin = 3.73518377850858 | erot = 1.74399251375944 | epot = -18.761713737683 | etot = -13.2825374454149 +774000 ekin = 3.73326270400355 | erot = 1.69319142559955 | epot = -18.7089915837464 | etot = -13.2825374541433 +775000 ekin = 3.70600761043796 | erot = 1.6566239979388 | epot = -18.6451690563952 | etot = -13.2825374480184 +776000 ekin = 3.66620956029523 | erot = 1.65229490555453 | epot = -18.6010419136787 | etot = -13.282537447829 +777000 ekin = 3.61649590749819 | erot = 1.68124406448108 | epot = -18.5802774198126 | etot = -13.2825374478333 +778000 ekin = 3.55892172037955 | erot = 1.74156460696009 | epot = -18.5830237753754 | etot = -13.2825374480357 +779000 ekin = 3.49505249872284 | erot = 1.82861083535278 | epot = -18.6062007829277 | etot = -13.2825374488521 +780000 ekin = 3.42606052970244 | erot = 1.93200454593087 | epot = -18.6406025252668 | etot = -13.2825374496335 +781000 ekin = 3.35141348725842 | erot = 2.04005284573706 | epot = -18.6740037834645 | etot = -13.2825374504691 +782000 ekin = 3.2700234367696 | erot = 2.14152553729048 | epot = -18.6940864252466 | etot = -13.2825374511865 +783000 ekin = 3.18141085684875 | erot = 2.22636120811957 | epot = -18.690309516577 | etot = -13.2825374516087 +784000 ekin = 3.08656488529642 | erot = 2.28735807349748 | epot = -18.6564604104105 | etot = -13.2825374516166 +785000 ekin = 2.98843914069599 | erot = 2.32136711573499 | epot = -18.592343707635 | etot = -13.282537451204 +786000 ekin = 2.89178850824096 | erot = 2.3295414984193 | epot = -18.5038674571453 | etot = -13.2825374504851 +787000 ekin = 2.8023307080712 | erot = 2.31656731751225 | epot = -18.4014354752266 | etot = -13.2825374496432 +788000 ekin = 2.72556137551752 | erot = 2.28924565772307 | epot = -18.2973444820957 | etot = -13.2825374488551 +789000 ekin = 2.6656985022175 | erot = 2.25498711354848 | epot = -18.2032230640058 | etot = -13.2825374482399 +790000 ekin = 2.62507547599935 | erot = 2.22062577794683 | epot = -18.1282387017979 | etot = -13.2825374478518 +791000 ekin = 2.60400664952963 | erot = 2.19166523694291 | epot = -18.0782093341748 | etot = -13.2825374477022 +792000 ekin = 2.60095165935059 | erot = 2.17186849882108 | epot = -18.0553576059557 | etot = -13.282537447784 +793000 ekin = 2.61278727243034 | erot = 2.1630579474879 | epot = -18.0583826680031 | etot = -13.2825374480849 +794000 ekin = 2.63509078851047 | erot = 2.16503786006958 | epot = -18.0826660971656 | etot = -13.2825374485855 +795000 ekin = 2.66245645585368 | erot = 2.1756290014367 | epot = -18.1206229065374 | etot = -13.282537449247 +796000 ekin = 2.68895951870523 | erot = 2.19088748025581 | epot = -18.1623844489478 | etot = -13.2825374499868 +797000 ekin = 2.70892452688332 | erot = 2.2056406086122 | epot = -18.197102586158 | etot = -13.2825374506625 +798000 ekin = 2.71873874100197 | erot = 2.21455364270924 | epot = -18.2158298332998 | etot = -13.2825374495886 +799000 ekin = 2.70000299973817 | erot = 2.2105054534633 | epot = -18.1930459030985 | etot = -13.282537449897 +800000 ekin = 2.65392049094459 | erot = 2.17300546859124 | epot = -18.1094633784201 | etot = -13.2825374188843 +801000 ekin = 2.82505345316557 | erot = 2.13616134654269 | epot = -18.2437522542245 | etot = -13.2825374545162 +802000 ekin = 2.90470228885208 | erot = 2.10953657420558 | epot = -18.2967762804394 | etot = -13.2825374173817 +803000 ekin = 2.96775259915972 | erot = 2.08137573430732 | epot = -18.3316657516683 | etot = -13.2825374182013 +804000 ekin = 3.01419864043949 | erot = 2.05336319944923 | epot = -18.3500992582319 | etot = -13.2825374183431 +805000 ekin = 3.03950260644552 | erot = 2.02738087501351 | epot = -18.3494208998051 | etot = -13.2825374183461 +806000 ekin = 3.04147612131243 | erot = 2.00524180159513 | epot = -18.3292553411016 | etot = -13.2825374181941 +807000 ekin = 3.02009152298814 | erot = 1.98876426014739 | epot = -18.2913932010452 | etot = -13.2825374179097 +808000 ekin = 2.97716861753119 | erot = 1.97979280799342 | epot = -18.2394988430722 | etot = -13.2825374175476 +809000 ekin = 2.91576405138726 | erot = 1.98007542312432 | epot = -18.1783768916846 | etot = -13.282537417173 +810000 ekin = 2.83951999042134 | erot = 1.99102014259852 | epot = -18.1130775498589 | etot = -13.282537416839 +811000 ekin = 2.75216924199515 | erot = 2.01344070753323 | epot = -18.0481473661025 | etot = -13.2825374165741 +812000 ekin = 2.65727213726343 | erot = 2.04739495988655 | epot = -17.987204513533 | etot = -13.282537416383 +813000 ekin = 2.55815479837528 | erot = 2.09215794771562 | epot = -17.9328501623443 | etot = -13.2825374162534 +814000 ekin = 2.4579662372483 | erot = 2.14630993623329 | epot = -17.8868135896497 | etot = -13.2825374161681 +815000 ekin = 2.35976627216073 | erot = 2.20788718914275 | epot = -17.8501908774147 | etot = -13.2825374161112 +816000 ekin = 2.26657574981526 | erot = 2.27454135627298 | epot = -17.8236545221636 | etot = -13.2825374160753 +817000 ekin = 2.18134946483051 | erot = 2.3436713345316 | epot = -17.8075582154243 | etot = -13.2825374160622 +818000 ekin = 2.10686415434699 | erot = 2.41251844145424 | epot = -17.8019200118806 | etot = -13.2825374160794 +819000 ekin = 2.04554497125477 | erot = 2.47824070198672 | epot = -17.8063230893767 | etot = -13.2825374161352 +820000 ekin = 1.99927680186843 | erot = 2.53799486411919 | epot = -17.8198090822204 | etot = -13.2825374162328 +821000 ekin = 1.96925307966866 | erot = 2.58905270243613 | epot = -17.840843198472 | etot = -13.2825374163673 +822000 ekin = 1.95590272109404 | erot = 2.62895986973405 | epot = -17.8674000073523 | etot = -13.2825374165242 +823000 ekin = 1.95890926741904 | erot = 2.65572860619527 | epot = -17.8971752902976 | etot = -13.2825374166833 +824000 ekin = 1.977310461331 | erot = 2.66804286174235 | epot = -17.9278907398948 | etot = -13.2825374168215 +825000 ekin = 2.00964945329754 | erot = 2.66544750505568 | epot = -17.9576343752703 | etot = -13.2825374169171 +826000 ekin = 2.0541442314356 | erot = 2.64849047615147 | epot = -17.9851721245422 | etot = -13.2825374169552 +827000 ekin = 2.10884212221679 | erot = 2.61877894563757 | epot = -18.0101584847866 | etot = -13.2825374169322 +828000 ekin = 2.17172935733676 | erot = 2.57890618406652 | epot = -18.0331729582634 | etot = -13.2825374168601 +829000 ekin = 2.24077304904372 | erot = 2.5322165119978 | epot = -18.0555269778081 | etot = -13.2825374167666 +830000 ekin = 2.31389012815757 | erot = 2.48241157684725 | epot = -18.0788391216955 | etot = -13.2825374166907 +831000 ekin = 2.38886546625953 | erot = 2.43305573632076 | epot = -18.104458619251 | etot = -13.2825374166707 +832000 ekin = 2.46326915871406 | erot = 2.38708705021977 | epot = -18.1328936256668 | etot = -13.282537416733 +833000 ekin = 2.53443656409172 | erot = 2.34645691970375 | epot = -18.1634309006758 | etot = -13.2825374168804 +834000 ekin = 2.59956439097001 | erot = 2.31199374937919 | epot = -18.1940955574388 | etot = -13.2825374170896 +835000 ekin = 2.65594316002407 | erot = 2.28352232981187 | epot = -18.2220029071513 | etot = -13.2825374173153 +836000 ekin = 2.70130042716651 | erot = 2.26019210855364 | epot = -18.2440299532235 | etot = -13.2825374175034 +837000 ekin = 2.73418787966583 | erot = 2.24090837049561 | epot = -18.2576336677656 | etot = -13.2825374176041 +838000 ekin = 2.75431729315362 | erot = 2.22474076448287 | epot = -18.2615954752233 | etot = -13.2825374175868 +839000 ekin = 2.76274241572831 | erot = 2.21121141264461 | epot = -18.2564912458202 | etot = -13.2825374174473 +840000 ekin = 2.76179432909388 | erot = 2.20041723497348 | epot = -18.2447489812793 | etot = -13.282537417212 +841000 ekin = 2.75470877418902 | erot = 2.1929795872171 | epot = -18.2302257783439 | etot = -13.2825374169378 +842000 ekin = 2.74495192414829 | erot = 2.18982916717498 | epot = -18.2173185080269 | etot = -13.2825374167036 +843000 ekin = 2.73536701720752 | erot = 2.19185320338424 | epot = -18.2097576371796 | etot = -13.2825374165879 +844000 ekin = 2.72739699207957 | erot = 2.19948517299773 | epot = -18.2094195817172 | etot = -13.2825374166399 +845000 ekin = 2.72069680081942 | erot = 2.2123834314525 | epot = -18.2156176491199 | etot = -13.282537416848 +846000 ekin = 2.71335245842044 | erot = 2.22935501274494 | epot = -18.2252448883063 | etot = -13.2825374171409 +847000 ekin = 2.70267547682563 | erot = 2.24859000802352 | epot = -18.2338029022618 | etot = -13.2825374174127 +848000 ekin = 2.68627674917249 | erot = 2.26812231570546 | epot = -18.2369364824441 | etot = -13.2825374175662 +849000 ekin = 2.66300406346419 | erot = 2.28632293043157 | epot = -18.2318644114456 | etot = -13.2825374175499 +850000 ekin = 2.63341305155328 | erot = 2.30223030137244 | epot = -18.218180770297 | etot = -13.2825374173713 +851000 ekin = 2.59966042962012 | erot = 2.31561676234611 | epot = -18.1978146090528 | etot = -13.2825374170866 +852000 ekin = 2.5649330756416 | erot = 2.32681511046273 | epot = -18.1742856028756 | etot = -13.2825374167712 +853000 ekin = 2.53268458711828 | erot = 2.33642702442706 | epot = -18.1516490280431 | etot = -13.2825374164977 +854000 ekin = 2.50591352350999 | erot = 2.34503055401556 | epot = -18.1334814938378 | etot = -13.2825374163123 +855000 ekin = 2.48667404327569 | erot = 2.3529787337437 | epot = -18.1221901932468 | etot = -13.2825374162274 +856000 ekin = 2.47592780438371 | erot = 2.3603420277346 | epot = -18.1188072483454 | etot = -13.2825374162271 +857000 ekin = 2.47367803113421 | erot = 2.36697110010333 | epot = -18.1231865475261 | etot = -13.2825374162886 +858000 ekin = 2.47922391314762 | erot = 2.37260088410896 | epot = -18.1343622136269 | etot = -13.2825374163703 +859000 ekin = 2.49150776537562 | erot = 2.37701216170971 | epot = -18.1510573435355 | etot = -13.2825374164502 +860000 ekin = 2.50937686487663 | erot = 2.38013993767848 | epot = -18.1720542190715 | etot = -13.2825374165164 +861000 ekin = 2.53170635734158 | erot = 2.382118173112 | epot = -18.1963619470209 | etot = -13.2825374165673 +862000 ekin = 2.55742566397641 | erot = 2.38328933411273 | epot = -18.2232524146946 | etot = -13.2825374166054 +863000 ekin = 2.58549482989182 | erot = 2.38419488615669 | epot = -18.2522271326816 | etot = -13.2825374166331 +864000 ekin = 2.61488040894193 | erot = 2.38555368952377 | epot = -18.2829715151176 | etot = -13.2825374166519 +865000 ekin = 2.64455846197211 | erot = 2.38821849293994 | epot = -18.3153143715761 | etot = -13.282537416664 +866000 ekin = 2.67354800293375 | erot = 2.39309523430222 | epot = -18.3491806539087 | etot = -13.2825374166727 +867000 ekin = 2.70096216873101 | erot = 2.40101926625376 | epot = -18.3845188516697 | etot = -13.282537416685 +868000 ekin = 2.72584498237102 | erot = 2.41260829133849 | epot = -18.4209906905118 | etot = -13.2825374168023 +869000 ekin = 2.74685098517846 | erot = 2.42808376703703 | epot = -18.4574721690819 | etot = -13.2825374168664 +870000 ekin = 2.7633451632292 | erot = 2.44707202924713 | epot = -18.492954609437 | etot = -13.2825374169607 +871000 ekin = 2.77488977650291 | erot = 2.46856883210016 | epot = -18.52599602569 | etot = -13.2825374170869 +872000 ekin = 2.78115731189941 | erot = 2.49101078905502 | epot = -18.5547055181929 | etot = -13.2825374172384 +873000 ekin = 2.78190152481948 | erot = 2.51241399948397 | epot = -18.5768529417016 | etot = -13.2825374173982 +874000 ekin = 2.77696693727655 | erot = 2.53063897251365 | epot = -18.5901433273283 | etot = -13.2825374175381 +875000 ekin = 2.76636320238677 | erot = 2.54374754553387 | epot = -18.5926481655429 | etot = -13.2825374176222 +876000 ekin = 2.75040698328634 | erot = 2.55039472458546 | epot = -18.5833391254864 | etot = -13.2825374176146 +877000 ekin = 2.72989722871737 | erot = 2.55017286738757 | epot = -18.5626075135949 | etot = -13.28253741749 +878000 ekin = 2.70625700359845 | erot = 2.54382115285145 | epot = -18.5326155736941 | etot = -13.2825374172442 +879000 ekin = 2.68156506710304 | erot = 2.5332421375899 | epot = -18.4973446215902 | etot = -13.2825374168973 +880000 ekin = 2.65843100587721 | erot = 2.52132217105652 | epot = -18.4622905934235 | etot = -13.2825374164897 +881000 ekin = 2.63972432917675 | erot = 2.51160592655705 | epot = -18.4338676718058 | etot = -13.282537416072 +882000 ekin = 2.62822235346356 | erot = 2.50790034757638 | epot = -18.4186601167335 | etot = -13.2825374156936 +883000 ekin = 2.62626662018779 | erot = 2.51387422610971 | epot = -18.4226782616929 | etot = -13.2825374153954 +884000 ekin = 2.63550251587674 | erot = 2.53269091102144 | epot = -18.4507308421049 | etot = -13.2825374152068 +885000 ekin = 2.65673814602945 | erot = 2.56668643769325 | epot = -18.5059619988685 | etot = -13.2825374151458 +886000 ekin = 2.68991716922188 | erot = 2.61709355073984 | epot = -18.5895481351839 | etot = -13.2825374152222 +887000 ekin = 2.73417552912835 | erot = 2.6838152242605 | epot = -18.7005281688277 | etot = -13.2825374154388 +888000 ekin = 2.78795008305904 | erot = 2.76526591420808 | epot = -18.8357534130565 | etot = -13.2825374157894 +889000 ekin = 2.84912017691373 | erot = 2.85831711202064 | epot = -18.9899747051915 | etot = -13.2825374162572 +890000 ekin = 2.91517691409144 | erot = 2.95839462905156 | epot = -19.1561089599533 | etot = -13.2825374168103 +891000 ekin = 2.98341766730812 | erot = 3.05976765321724 | epot = -19.325722737928 | etot = -13.2825374174026 +892000 ekin = 3.05115351194122 | erot = 3.15603968509377 | epot = -19.4897306150129 | etot = -13.2825374179779 +893000 ekin = 3.11590366932995 | erot = 3.24080527058909 | epot = -19.6392463583964 | etot = -13.2825374184774 +894000 ekin = 3.17554452677574 | erot = 3.30838806048503 | epot = -19.7664700061104 | etot = -13.2825374188496 +895000 ekin = 3.22839008199059 | erot = 3.35454380329715 | epot = -19.8654713043472 | etot = -13.2825374190595 +896000 ekin = 3.27319974841242 | erot = 3.37700709675264 | epot = -19.9327442642579 | etot = -13.2825374190928 +897000 ekin = 3.30912548213112 | erot = 3.37578333286277 | epot = -19.967446233953 | etot = -13.2825374189591 +898000 ekin = 3.33561719165196 | erot = 3.3531309986516 | epot = -19.9712856089931 | etot = -13.2825374186895 +899000 ekin = 3.35230310065721 | erot = 3.31323476899373 | epot = -19.9480752879843 | etot = -13.2825374183334 +900000 ekin = 3.35886034343544 | erot = 3.26162723368974 | epot = -19.9030249950731 | etot = -13.2825374179479 +901000 ekin = 3.35489762596209 | erot = 3.20446448625264 | epot = -19.8418995298029 | etot = -13.2825374175882 +902000 ekin = 3.33988398696538 | erot = 3.14778460706124 | epot = -19.7702060113224 | etot = -13.2825374172958 +903000 ekin = 3.31316641783821 | erot = 3.09687096396604 | epot = -19.6925747988938 | etot = -13.2825374170895 +904000 ekin = 3.27411465308455 | erot = 3.05580881507587 | epot = -19.6124608851232 | etot = -13.2825374169628 +905000 ekin = 3.22240761769978 | erot = 3.02727711778411 | epot = -19.5322221523689 | etot = -13.282537416885 +906000 ekin = 3.15843123273498 | erot = 3.01257047454492 | epot = -19.4535391240911 | etot = -13.2825374168112 +907000 ekin = 3.08369712964382 | erot = 3.01180553940022 | epot = -19.3780400857413 | etot = -13.2825374166972 +908000 ekin = 3.00113487274611 | erot = 3.02423547951158 | epot = -19.3079077687759 | etot = -13.2825374165182 +909000 ekin = 2.91509126886064 | erot = 3.0485809791401 | epot = -19.2462096642835 | etot = -13.2825374162828 +910000 ekin = 2.83091809167562 | erot = 3.08328866526031 | epot = -19.1967441729738 | etot = -13.2825374160379 +911000 ekin = 2.7541604271422 | erot = 3.1266566210814 | epot = -19.1633544640806 | etot = -13.282537415857 +912000 ekin = 2.68982240100996 | erot = 3.1767030385921 | epot = -19.1490628553551 | etot = -13.2825374157531 +913000 ekin = 2.64026279373643 | erot = 3.23106967523778 | epot = -19.1538698849232 | etot = -13.282537415949 +914000 ekin = 2.60494541465082 | erot = 3.28757760697213 | epot = -19.1750604377642 | etot = -13.2825374161413 +915000 ekin = 2.58331294239456 | erot = 3.34356245911015 | epot = -19.2094128182448 | etot = -13.2825374167401 +916000 ekin = 2.57222527647779 | erot = 3.39542630316431 | epot = -19.2501889969159 | etot = -13.2825374172738 +917000 ekin = 2.56717379817942 | erot = 3.43991413449175 | epot = -19.2896253504428 | etot = -13.2825374177716 +918000 ekin = 2.56366862210109 | erot = 3.47431911616615 | epot = -19.3205251564115 | etot = -13.2825374181443 +919000 ekin = 2.55808580304574 | erot = 3.49688251813148 | epot = -19.3375057395072 | etot = -13.28253741833 +920000 ekin = 2.54828083364558 | erot = 3.5070678678649 | epot = -19.3378861198184 | etot = -13.2825374183079 +921000 ekin = 2.53385837590705 | erot = 3.50557961685233 | epot = -19.3219754108608 | etot = -13.2825374181014 +922000 ekin = 2.51606053239869 | erot = 3.49409623216883 | epot = -19.2926941823441 | etot = -13.2825374177766 +923000 ekin = 2.49728908788132 | erot = 3.47476611576438 | epot = -19.2545926210732 | etot = -13.2825374174275 +924000 ekin = 2.48035717202194 | erot = 3.44958564398511 | epot = -19.2124802331591 | etot = -13.2825374171521 +925000 ekin = 2.46765713254659 | erot = 3.41982437264767 | epot = -19.1700189222178 | etot = -13.2825374170235 +926000 ekin = 2.46048446158288 | erot = 3.38566546873097 | epot = -19.1286873473806 | etot = -13.2825374170668 +927000 ekin = 2.45872404317125 | erot = 3.34617863031278 | epot = -19.0874400907354 | etot = -13.2825374172514 +928000 ekin = 2.46097855171065 | erot = 3.29964380838023 | epot = -19.0431597775946 | etot = -13.2825374175038 +929000 ekin = 2.46505358069594 | erot = 3.24413140257229 | epot = -18.991722401002 | etot = -13.2825374177338 +930000 ekin = 2.46859437787823 | erot = 3.17816487157566 | epot = -18.9292966673187 | etot = -13.2825374178649 +931000 ekin = 2.46965047267191 | erot = 3.10127887080617 | epot = -18.8534667613313 | etot = -13.2825374178532 +932000 ekin = 2.4670173255647 | erot = 3.01434778959557 | epot = -18.7639025328451 | etot = -13.2825374176848 +933000 ekin = 2.46031519134382 | erot = 2.9197399878057 | epot = -18.6625925965562 | etot = -13.2825374174067 +934000 ekin = 2.44985996562476 | erot = 2.82081794784481 | epot = -18.5532153305218 | etot = -13.2825374170523 +935000 ekin = 2.436420580333 | erot = 2.72162862765433 | epot = -18.4405866246576 | etot = -13.2825374166703 +936000 ekin = 2.42095423708767 | erot = 2.62651830215161 | epot = -18.3300099555418 | etot = -13.2825374163026 +937000 ekin = 2.40438434932027 | erot = 2.53973621279557 | epot = -18.226657978095 | etot = -13.2825374159791 +938000 ekin = 2.38744919935998 | erot = 2.4651292336249 | epot = -18.135115848703 | etot = -13.2825374157181 +939000 ekin = 2.37062067073867 | erot = 2.40593643839711 | epot = -18.0590945246642 | etot = -13.2825374155285 +940000 ekin = 2.35407564445261 | erot = 2.36465978724872 | epot = -18.0012728471164 | etot = -13.2825374154151 +941000 ekin = 2.33770002396805 | erot = 2.3429775907629 | epot = -17.9632150301122 | etot = -13.2825374153812 +942000 ekin = 2.3211100477539 | erot = 2.34167204177044 | epot = -17.9453195049536 | etot = -13.2825374154293 +943000 ekin = 2.30368578977883 | erot = 2.36056240878928 | epot = -17.9467856141281 | etot = -13.28253741556 +944000 ekin = 2.28462216192276 | erot = 2.39846175869457 | epot = -17.965621336385 | etot = -13.2825374157677 +945000 ekin = 2.2630091294477 | erot = 2.45319770839139 | epot = -17.9987442538757 | etot = -13.2825374160366 +946000 ekin = 2.23795189081835 | erot = 2.52174524491464 | epot = -18.0422345520714 | etot = -13.2825374163384 +947000 ekin = 2.20873145000821 | erot = 2.60050188215201 | epot = -18.0917707487932 | etot = -13.282537416633 +948000 ekin = 2.17498954570766 | erot = 2.68569096156255 | epot = -18.1432179241464 | etot = -13.2825374168762 +949000 ekin = 2.13690579381781 | erot = 2.77382147859291 | epot = -18.1932646894412 | etot = -13.2825374170305 +950000 ekin = 2.09532426392926 | erot = 2.86208910103834 | epot = -18.2399507820441 | etot = -13.2825374170765 +951000 ekin = 2.05179334892108 | erot = 2.94860198731117 | epot = -18.2829327532513 | etot = -13.282537417019 +952000 ekin = 2.00850116617196 | erot = 3.03236285196215 | epot = -18.3234014350193 | etot = -13.2825374168852 +953000 ekin = 1.96811370411823 | erot = 3.11301524923778 | epot = -18.3636663700751 | etot = -13.2825374167191 +954000 ekin = 1.93354422096465 | erot = 3.19043207950452 | epot = -18.4065137170385 | etot = -13.2825374165694 +955000 ekin = 1.90769299354898 | erot = 3.26426019429227 | epot = -18.4544906043215 | etot = -13.2825374164802 +956000 ekin = 1.89319483668346 | erot = 3.3335310510213 | epot = -18.5092633041882 | etot = -13.2825374164834 +957000 ekin = 1.89220136687493 | erot = 3.39641763043281 | epot = -18.5711564139026 | etot = -13.2825374165948 +958000 ekin = 1.90621184327196 | erot = 3.45018116338437 | epot = -18.6389304234696 | etot = -13.2825374168133 +959000 ekin = 1.93595602572738 | erot = 3.49131884016615 | epot = -18.7098122830149 | etot = -13.2825374171214 +960000 ekin = 1.98132739808155 | erot = 3.51589596586286 | epot = -18.7797607814332 | etot = -13.2825374174888 +961000 ekin = 2.04135467404736 | erot = 3.52022622800403 | epot = -18.8441183199515 | etot = -13.2825374179001 +962000 ekin = 2.11395441310799 | erot = 3.50134462367084 | epot = -18.8978364550807 | etot = -13.2825374183019 +963000 ekin = 2.19624676899701 | erot = 3.45688460164827 | epot = -18.9356687892675 | etot = -13.2825374186222 +964000 ekin = 2.28502253915305 | erot = 3.38607259923977 | epot = -18.9536325572173 | etot = -13.2825374188245 +965000 ekin = 2.37703902445876 | erot = 3.290048679397 | epot = -18.9496251223776 | etot = -13.2825374185219 +966000 ekin = 2.47063968725093 | erot = 3.1723513983338 | epot = -18.9255285040288 | etot = -13.2825374184441 +967000 ekin = 2.56372995923146 | erot = 3.03797961445187 | epot = -18.8842469918799 | etot = -13.2825374181965 +968000 ekin = 2.65424153344269 | erot = 2.89333166097639 | epot = -18.8301106122161 | etot = -13.282537417797 +969000 ekin = 2.74102206186552 | erot = 2.74597895251273 | epot = -18.7695384316796 | etot = -13.2825374173014 +970000 ekin = 2.82317857356224 | erot = 2.604190086995 | epot = -18.7099060774559 | etot = -13.2825374168987 +971000 ekin = 2.8994689638118 | erot = 2.4760495859706 | epot = -18.6580559662902 | etot = -13.2825374165078 +972000 ekin = 2.9692788351105 | erot = 2.36783972481189 | epot = -18.6196559761964 | etot = -13.282537416274 +973000 ekin = 3.03160430536472 | erot = 2.2837390116559 | epot = -18.5978807332491 | etot = -13.2825374162285 +974000 ekin = 3.08487810189262 | erot = 2.22552920107224 | epot = -18.5929447193212 | etot = -13.2825374163564 +975000 ekin = 3.12708218339791 | erot = 2.19270938701088 | epot = -18.6023289870154 | etot = -13.2825374166067 +976000 ekin = 3.15606698313496 | erot = 2.18294126797245 | epot = -18.6215456680199 | etot = -13.2825374169125 +977000 ekin = 3.16994500148915 | erot = 2.19267118134068 | epot = -18.6451536000414 | etot = -13.2825374172116 +978000 ekin = 3.16742946230438 | erot = 2.21776877388408 | epot = -18.6677356536463 | etot = -13.2825374174579 +979000 ekin = 3.14804045634032 | erot = 2.25406876454721 | epot = -18.6846466385122 | etot = -13.2825374176247 +980000 ekin = 3.11216367300116 | erot = 2.29776911310777 | epot = -18.6924702038109 | etot = -13.282537417702 +981000 ekin = 3.06099214892659 | erot = 2.3456929996696 | epot = -18.6892225662862 | etot = -13.28253741769 +982000 ekin = 2.99639964718071 | erot = 2.39544433336442 | epot = -18.6743813981403 | etot = -13.2825374175951 +983000 ekin = 2.92078844001815 | erot = 2.44547840699747 | epot = -18.6488042644435 | etot = -13.2825374174279 +984000 ekin = 2.83693459158518 | erot = 2.49508912549767 | epot = -18.6145611342876 | etot = -13.2825374172048 +985000 ekin = 2.74783419632812 | erot = 2.5443043349293 | epot = -18.574675948205 | etot = -13.2825374169476 +986000 ekin = 2.65654531631453 | erot = 2.59369131479764 | epot = -18.5327740477957 | etot = -13.2825374166835 +987000 ekin = 2.56602543639744 | erot = 2.64409903932047 | epot = -18.4926618921587 | etot = -13.2825374164408 +988000 ekin = 2.47897321242724 | erot = 2.69638105728562 | epot = -18.4578916859573 | etot = -13.2825374162445 +989000 ekin = 2.39763961356463 | erot = 2.75059396001095 | epot = -18.4307709898088 | etot = -13.2825374162332 +990000 ekin = 2.32368779513216 | erot = 2.8060334288419 | epot = -18.4122586401602 | etot = -13.2825374161862 +991000 ekin = 2.25825301239778 | erot = 2.86226671700632 | epot = -18.403057145624 | etot = -13.2825374162199 +992000 ekin = 2.20187988804497 | erot = 2.91825634883864 | epot = -18.40267365322 | etot = -13.2825374163364 +993000 ekin = 2.15452775813786 | erot = 2.97231721272995 | epot = -18.4093823873994 | etot = -13.2825374165316 +994000 ekin = 2.1156117684003 | erot = 3.02214023540268 | epot = -18.4202894205965 | etot = -13.2825374167935 +995000 ekin = 2.0840816135671 | erot = 3.0648940369717 | epot = -18.4315130676401 | etot = -13.2825374171013 +996000 ekin = 2.05854312781033 | erot = 3.09743221589021 | epot = -18.4385127611221 | etot = -13.2825374174216 +997000 ekin = 2.03742523644506 | erot = 3.11662356541409 | epot = -18.4365862195703 | etot = -13.2825374177112 +998000 ekin = 2.0191844917443 | erot = 3.11978989754515 | epot = -18.4215118072117 | etot = -13.2825374179223 +999000 ekin = 2.00252382756565 | erot = 3.10518925660486 | epot = -18.3902505021827 | etot = -13.2825374180121 +1000000 ekin = 1.98658902728357 | erot = 3.07244218051013 | epot = -18.341568625748 | etot = -13.2825374179543 + 1000000 0.088292846 -1.1874188 0.041070751 -1.0221862 -7.1515284e-05 +Loop time of 31.8631 on 4 procs for 1000000 steps with 16 atoms + +Performance: 27116.007 tau/day, 31384.268 timesteps/s +99.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 | 4.7557 | 14.198 | 24.52 | 210.8 | 44.56 +Bond | 0.22678 | 0.45105 | 0.74273 | 29.9 | 1.42 +Neigh | 0.00012 | 0.00012675 | 0.00013 | 0.0 | 0.00 +Comm | 2.6837 | 2.8338 | 3.0258 | 7.8 | 8.89 +Output | 2e-05 | 2.75e-05 | 3e-05 | 0.0 | 0.00 +Modify | 0.43472 | 0.8763 | 1.3871 | 38.7 | 2.75 +Other | | 13.5 | | | 42.38 + +Nlocal: 4 ave 7 max 1 min +Histogram: 1 0 0 0 0 2 0 0 0 1 +Nghost: 10.5 ave 12 max 9 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 38.75 ave 63 max 11 min +Histogram: 1 0 0 0 0 1 1 0 0 1 + +Total # of neighbors = 155 +Ave neighs/atom = 9.6875 +Ave special neighs/atom = 3.75 +Neighbor list builds = 6 +Dangerous builds = 0 + +#write_restart config.${number}.* +Total wall time: 0:00:31 From ec052ea99a33a1129e3432ac4ba9a6c8ce088132 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 10:45:25 -0500 Subject: [PATCH 420/557] Update docs: angle_mm3 --- doc/src/Eqs/angle_mm3.jpg | Bin 9222 -> 0 bytes doc/src/Eqs/angle_mm3.tex | 9 ------- doc/src/angle_mm3.rst | 39 +++++++++++---------------- doc/txt/angle_mm3.txt | 55 -------------------------------------- 4 files changed, 16 insertions(+), 87 deletions(-) delete mode 100644 doc/src/Eqs/angle_mm3.jpg delete mode 100644 doc/src/Eqs/angle_mm3.tex delete mode 100644 doc/txt/angle_mm3.txt diff --git a/doc/src/Eqs/angle_mm3.jpg b/doc/src/Eqs/angle_mm3.jpg deleted file mode 100644 index 5b9f3e34f091f5a2d439294e9c5a1802a2885fb4..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 9222 zcmdscWl&sA)aD%q7~CPa%_NWj3GPm?5Htjbke~w@+y)6A+%1sc?(P~K5(qAXI}8#a zgb;Lj-*0R8tF5itZ};b(u5+uaZ`ZAU?mhRMexAOYyITcFUMMIl03Z+mfbJV`w*bfi zIM~<_Y%ClI1cHl;gGWF?NPv$|Kto1OOu<0Q#K=HPPtOc{%Ervf38klJ7kbRe&BM>n z&%`DoA-Efx#GzMML(>NX#jDPLn$v@EkMfP6<7V!Us?0*3JpSVx}0T^`u@xY{j6!7PgBkZEm0dWmN zZvMP-`N7bhF~HufPtD96IEA6UWZ3zFOiE*KU|F{yVmJBAf<`)`?bbTCLW?QFCrA-Vok` zFF$NcP&`I|Eo6GKy{=b=AYMLQR=}alXqDmm@y8nM2vZh%?}{jU-SA~KI_qk(lvt;; z=J-uuMdfqfU6fC=d5rkrN;lt9YADT-n(e14t)H^B$N3|h9hR*=rC%AQdPH-qq&$w8qTym}wtH*p3MddRIG}wkXDv>BX7;uvsZX_kwpLGW zHJ_4a_fJES2gKmwAD}w%XOv}(v^5`xyS?!B#`1K2<#L8+hhhaf;WF|35dS4ja|@k3 z_^nR5OVxNjZnTi#(EnJ2H=e|Fbyg9R)L>!29@CbBhy8gJHbxOOK-69B`sOd4x71nl z9WaI^)mL!(jL=5N%^+yT$f6>n?lhxhNx&N%6B777t(@hw6HUugw}6ZSAGLxZ#w9q_>yI=-P+Dcu@y z+92IVr+)kFy0!=8`~iAfV)&+CIIy3rJQXF4)PR`DQx5DtAoHj|xS_pDi?SQ19#++> zAW_T_R1}@V3fs?`uIH%%vkGZ3JdRJtA1jgT>JWMU*+*QmBCz@l>v7*1c^26&5=AlR zUB1`XU@tE>@fRtxwM+FC%@S?uJT#;w1O9#hxKdg)4cOnUufX9gi)hf6X%9`cIS z?|arMXcU+6LMpCM=UE8XX3ZG1rPJa;Bgc8^JTX(-+jyxZ&0t1cv8xHNhVTk4djHg13ArN zpBrbdoi53Qu2o!0U79*Id}mc3c^7@YiOp(eIBnh#d4pk6zg5vp`(?qvR!C=Nqb8?H znDJ`_XcwCuTpa&ATrgfyTOKR*(<&gApq6Jrkgtb<^A*zWyiA*3UisSxG{jLb9Q9uP z`f9i}&UY226gZCsxM*wYqmr{9CT%C-u~xOW3LdE+$2?NzmH0)?6qZFu%U*Wlrq6tQ zUdX97#A@(j810}P1S7Eq%Z9ICi{!R9k^&nT=-KPp~)C!n&t8PTEof3G86Tcry)7mNNASIveiBjvz;~ zJ+MX=Hp9jBY{IbcU66edSZ$-V&cAqVYMacEE7zCsBI7iAfokm|^#6 zXriA{5t}ue{};2g@?0AsRHFLB?I`C0Kw7&wS&;_6~g0Wf;uqK_h{sIiV%DA(rYgm%&ATfKwq}6IVZaDx)F2$wr`f#e6CZ>@7bJ z1w%`)O>-Ulm3JlU&^w&wq63ivG@08CiJAoEY`YtNv1(2lnL`%TmM& zn|gW+5hKqZ-vN5xmBPtyhk8U9y1?1Yey)kSY^z?A&TL`Ka<>r{<*N2}xjF1g-`LNI zei&N-6q@n?g|65Jm(7Oacy4r8*3@tO(1Z7lk^Y<^bfHI-?n2ktHS=cU;y!EbPlnQ? z`l9CB+~2o-_0FkL@(pXW+q?si?bhIig1j&m)95md!}s*7mrNhv)1x-O7?^rnR4*N| zbA{%fCc1FGPGh_LsFkrUv&)V#a^7az-d0;v|G-^PXW!BBK^kd;;9<6th*@>Zs>^mI zTr|C*KF`3$?WFLV`dV{%G$9G^}eeEiMj^|~>6 zrI$83&K`jaK2Xd0{vEl91NAG7mI@t%sLMNcP>lbkLs%Z6-;kkO(u1TI`WxSWHj)0| zMyKtNhqydC!$f<`nk4i{5>5+vyf*Oi@O7dq{M7rzYQY%~SkBEFs^IH&`msg`RiB=@ zJ#xmHB7H+sV5Pqi*K6mN5X@ZlwvNDzLAacW?1jC61X~YUDf(tJd7t5M9jLjXNfVGd zsMUbT(1&r_!t5%d!5ohVna`LfOX`>ECcCQ_mQ~<^-+DvUc*g87iNDo5XA=CzZ`WO$ ziSqGveAqX2!l%p`!a3lj0nu0GWo^k74e>tILJIGPuX{^LtVD=Ioh!?KPdyN_cbGBJ zE-S`>)+h*C+4_tPIEV}}aASSL9}>4cKI+j9d@mYw{>>R&v`&}ApxCe~!!Q-=IR?>} zH-~#hTtsxw7$kk^wD9`ov4xrCOv6l;$D}6DcJ5Yt2gv-qPEbF|!l{pP*P8r|*-&+S zxLnksn+l6nr+6nG58P}#bq*XmiScaBvC%?bz7(36`(|!2L^6#2j_o0$B?Bq?x+`yW z(V$XYppRORhjqU1Y;5?FLmp}%vz-v_m-RMdzT8;rmVr&FZOZBncm)TKUfiM|n_c1o zH84321%{X5VBWw%h%n4+^;RKWuYTu zl>P~)%_F;&Hz)TaD<@nNS4{NF0l|u`&m?>BonQGk3rO z?PEf5)XN1#k03#83nY}xhxZlRRcaQ*(4+iO$N1rPbsE<6jGT=T30l)Vj+F$D-fA{O zf^S?GXTrq9BeN$hDJk+~Wtc`lDSrj#HumXsn5GMFq1(*bcy5zK_-Gf%sjWYhRb}fz zCFhfI48d(-!{y`Q#mr20914DTk1M{CehH8bP{US5Zbx|)T|}(q-E!DoeG(8^&p^*9 z^5JC7jcgVCX!#aQvxqAqe%1xanbdk7TcxPOzF-I+o!s^LOF68v-fVYEKX2RcqS&ig z4$}>-Agj)!Z6X$I`D091# z)T3eI^mhG(^Ji{2x!_9DOZGXCG&tT9??bxBE%f9~DA!iT8mCJ!YhAeTBkM*b4e{tc zCAObW{J#*8FZ+o$!<157qKlfroDRHd5Hx)Hn}@mv!ujP4|A|$92srqKz)9Wv(nPa2HC@VJWMq?KVB9NW^)EAmM6Nh&EVf=e`h|LC<1X7A$fDTX%cH9tI@J}#A`Lv~UlGy() zO6rT>i=EG{p(In@Ryu5ykS1t58-iA65v6V_o&R(-9;tVyH@_tIbahTM3eh`JEB0a& zyfhE!pH`Q?qTEVAyO&rs^xvM8%nI38UTmGg>@Sk{boLxSWZeN3X)ph33SF_tIEigJ z_d9`RG>r=VpBbFa8bzrg$^|}`+B(i_>d_OM_W7NGDW}Ik@)Q~%dFKq?89SE|!I>Xw zuBxxJTU0o7ppyD_1~1*`{6C{1S)EPq263zpRB*%+I35H=?Q%AX`I16NNg@{&b&5p~xK64RwKX_n}pOl_n zzjZ2aOW4L!_Q5;*^E*EXEQLlQVDp$m;SHXLn^$9Niu6QYb8P%Ci7ys&8ES?!{8b)r zdd?fGmlt*o%!M3J69(Y4Eho{`1mVC`q;S;pAih<*C)~I{{q;Vu)C3$U5p>XrHfuO6 zVrFAH-qWw3ULPvaO51{)af+v!VDfyXb&ofI58{|f8K<7 zeV{Ct2Uu8SVE5}v`}GXNTE~Rr__n>=MrpEV9e+P1O7FO8vp0|UC*oD$LIbb!?rZ~< zXHs=TM_m9K!|7cHH`*86r&tK5wTvT|FM!V^YgT{bs>7#dTV$sI4SPSEDop69wWba7 zub04Zo7|CDdT?WSgST-i;MCqtF|gISx&tU(nJ#{D+01)5%T3y$j(QX(%k2zV z3Ie7{M?JUvMxM6kKdsMIH`_*P3C?~rvig=pEh;IIs(niV`f;sTBO0BOtFPpL_-LkV zW>0C*`p=nUUqeiP@w1S+g*zb3O=}P3THc-!NZvLfgO?SLmc}Rqr-vm=ex7Niv%g4# z+oVN>D!y&-LSkVo7D1P;BpEKrSH*k*>rE?D%oN4KekSAXBv zJjf68jfFC|kCUp-?a&GF4Z+G^7N(1t8wyab$G4Zale6NKX5OXFRySEc9owY>yaj{wR_= zXj;(>M2GClq73s3=b^#S#`!9RhBKLsao&eQO9IcB3N&0#OCR_+Dm) z@{A`Mb5at4fx1dNNfhn?+`1>eNUq>*34lw;@e?w7U>O=VbJcc2EcHUBW;aM`1z4)<*09AVKUfOfJG|P0j zc}&zd1V%p{1797%Zvi(yZmAk?xjR5k=vGPbR=`)ab_!u2=Ud`a$4v*BpONTj7o7>F z0QGxo*T?Uy9bWb3N7cnHaWgGOzjnJ$B)`!1B}=$cl%3#2492S*8jQa~Ima@6x4gvC z`Vi3i4*XaL2;i3asf}e+r=h@!1Hf6hHbh>ku&; z`n_Rm;FAVD)xs>zhQQFZSkRozx(aSp&BA_)T36<3Y#3=ru%507f-CLBp0MrFo<@Id zB3(Cme0Ix*_EwiWk?h^_4+4HeJx+vmJl40}Z021VI1uo4-X1N>cV^X2b7>)o3zTuqzBD6W! zT*JqqYZ6iC!~0D=zI#%=zM(dj+CVK_Exzqa5NLCE70QSUCu zEJy#Hmo3O4D)T1-;Qozy#+;5XA^A;RK}AdtFt+qS~y@^$_1 zKj*#01kSQG;-8dyd7dij46pju8;D}14+NgY;CraT^nO-;pI90VCz_xbdbB*hIGhz1 z=~gkeH>2?9uwVl0`sHswPpfdh^L{knUZ0h%!Sh*zj+jzZ5b|vA;diwK@4-#gGSGn& zMdV4p@TfFs?LHx1MVa((e$0H?b|n%^fDG4!=|E?RKm!hH*pAwDYn|(sovci8{0r18 zOMe!Hc5$xJGZFbidA{$_x@NAU*)FqAibQX0g0!{iEuyC&gU;EpM) ztLNWhy{iE27-+@RYY07g)1NFty1|M^^&W?IA4Yik=e?`0kY^IMv9tV32-j!Ckl8;} zQ%Z8@{B-K`J3E!)<{tzWUK^I;*t6B9884JS;_C~H`D|7wIp=(-fn|%&rM0}_vt4=K z)DX9IlWMjz%RK3=?DZ&pZDFCP?xcvfKyuieGz`R|#JLCxP-cq+8`MQ+Czb-*ktCk9 zz*+|@q;aB6j4_?I??X#_$-E+U|FYUDaLe?}L!vtE;EiTYj7EgISCh`EIUMTOM1&TN zZC9eistC!SH|82?k9^Eq{M@0Lrx;zD*&<9&fLAw@{KK7L!LWOlr}+7&tfwWOeoNBA z^!MzE^!T(3-m(&PxNT%C+5B(_(#BiT!c@rhm+3`!m0|G*tc!GMv-eVUlHC%BK*2GI zDr(~Qy7|kyEq1xwX-C74E#|jUpvh{j$_%=5Cprc*OJyUe!IIz2P9tR;T6vb4%!TnE=slh77I|=+IAqvCAF!i7sjJ*VG-8U$qozpyTv*}9 zp9Vi_&j3%77teyc`BN~~yv6d$RyUP6a|tsm7RRtzrDr;6VHs-Bj(Cj;4^;N^l4OVGUnK53s zMN8-OPbkk4ny4vsgS$JBG<)EKe#||&$7m?}M^*!;9DmUH*?ZD?**BBVwI4|Fvh!k( za#VjFuG82dI$OUaxP0pIn};6G$pLLCBSk8uGUzn{M0w!{Scxt6;SW0l1ig%vNuSCR zeA7n}^EREwHseh=GHRDtI18Qc(}m-{9WsWdu^dg{L~fh3v%emZrTq zm$M5AkfV=l31;{x8)H!(^7D*k;^ubhVwX5)oL({3H&{_9cDJY4 zEpL7vP6xp>|9}~jEx@pyZja0}f=333!Lw|ginu9h+*XMeX@MOs*ZnK!wXjMH{Z~eR zVUf(5m{IsIT5)!mIG%~HF>jh-+tWpzx4>*14$J57_jP`Q)OWx}$uwnQh%2sPkERU< zR)ic~!~lzZof0e0V=&mdhmSsk2m(!;$QU+$)!R@zLiaE^rA4Wc0NF^8?@oOFn&zWd z${k=8`)@VpbLHStLu=bI7#=7+An3Hz7h*EXNK(0C>yr9#@s%WSIYRS`Caq-Rdtg}+!EOB%8Z_0cordMgWx&bHjW zaZ0>pd>M*U8kn?{C36?PYIQFUKce`D&<Q7L^=56M11ENlqchq{Tu{K;Vl#~iW z3Z7!#_4~6BURt>~X++1MFe0=9pG1xqNdM9()`t#lB(c$KI2fHs(@AiIUnu_Qt|Yz# zX0h)JFRJBpDF>nD5VW)UBYLT7oudd0I4!YGWG&GLCXou*yhJ>j`|GDZJO}T=<$bH%VO{H3P(l{TEGuyH z!24KG%JHsQm#B&_e(qrAQElzBU3phZtfVirK2hySHJFW!Vei5q$0d=Vzjzsbc-tK; zdGX#NCuIG&_6L8XAr2(*Qk=6YFVm=xnB#F{#kC$Qz8d$ZX7v;KNjJoqN#wf6Su=WR z-Y=1^#FLR3?Bv-Qu;AIU8DPqgU+|}PZH}K@uNA=j1M~22eb>J5DB!c7v`enA| zLWap`Wv*+PP1%vehy&{d#RBE+2J0*W%852K3FCnxoEh>7AOmz zk8Z!lj5Mov3sI{P>O=^}(v|Iu@$3S+HiY;qtH3vl2I&(9@XA!*ZO z&5V^XqqzgTIm>(%3~F=XHM>3fQx&o8_f_03gPnIvTK>7rB%2L!Z$^)RSH$BE={VBOoeU?09Zg2ep;DC0APid(>t6Kf+$?A81yYBRII`n-qIDD@FPPqT3j5f=t7d#YW% zo*if^NnC8SXHBK_09!2IP!#CtxUS+O-BJUm)@MJDyDOTzy`0Tg$Q= z4W*LkS#WCH()AV;@~G`6e|%34a4v37QGJ=)kTt^zq^HRz`TSI#F8_B8jnaH`Poe{> z4j|rm#cMZDRXJWhb{PJXLe@SqSt!TxB~~Kj{=h^7yZql{U`=WI&VU;7H&LB4kLq1p zPfWkv0ns(HJpaeAJ!Gv(d3ho*GR0FnkM=h}1WIb}w#sE%N@r#CK`Lq4{ph87b!XHL#%AxYAZptpw*K}I4ukoIWjnAmw@XQv7T<^<< z16}`_-PT7637$tVEUlmlFt^`uK0O31^bQHP9<$Z9EJ&ZO-#@R$fmAo?t5^ z{81ScH^+v35Qr<}ijHtx|G~JRCqo(Bp4~9H@sWo*P1xVc(LYlB3wV)T0;f{GwW_XD zUZvH#@U>W?l7E$hqVGG!v9#g}>#={cd?zHIm1iz9JsUPTsMz)c}5CqQnXH` -.. image:: Eqs/angle_mm3.jpg - :align: center +.. math:: -where theta0 is the equilibrium value of the angle, and K is a -prefactor. The anharmonic prefactors have units deg\^(-n), for example --0.014 deg\^(-1), 5.6(10)\^(-5) deg\^(-2), ... + E = K (\theta - \theta_0)^2 \left[ 1 - 0.014(\theta - \theta_0) + 5.6(10)^{-5} (\theta - \theta_0)^2 - 7.0(10)^{-7} (\theta - \theta_0)^3 + 9(10)^{-10} (\theta - \theta_0)^4 \right] + + +where :math:`\theta_0` is the equilibrium value of the angle, and :math:`K` is a +prefactor. The anharmonic prefactors have units :math:`\deg^{-n}`, for example +:math:`-0.014 \deg^{-1}`, :math:`5.6 \cdot 10^{-5} \deg^{-2}`, ... The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/radian\^2) -* theta0 (degrees) +* :math:`K` (energy/radian\^2) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian\^2. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K` are in energy/radian\^2. Restrictions """""""""""" @@ -58,12 +60,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - ----------- - - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_mm3.txt b/doc/txt/angle_mm3.txt deleted file mode 100644 index 9ae032c4ff..0000000000 --- a/doc/txt/angle_mm3.txt +++ /dev/null @@ -1,55 +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 - -angle_style mm3 command :h3 - -[Syntax:] - -angle_style mm3 :pre - -[Examples:] - -angle_style mm3 -angle_coeff 1 100.0 107.0 :pre - -[Description:] - -The {mm3} angle style uses the potential that is anharmonic in the angle -as defined in "(Allinger)"_#mm3-allinger1989 - -:c,image(Eqs/angle_mm3.jpg) - -where theta0 is the equilibrium value of the angle, and K is a -prefactor. The anharmonic prefactors have units deg^(-n), for example --0.014 deg^(-1), 5.6(10)^(-5) deg^(-2), ... - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/radian^2) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian^2. - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER_YAFF package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none - -:line - From 5d6137fd691af371761a4a8ee2a811765574915d Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 10:55:06 -0500 Subject: [PATCH 421/557] Update docs: angle_quartic --- doc/src/Eqs/angle_quartic.jpg | Bin 5273 -> 0 bytes doc/src/Eqs/angle_quartic.tex | 9 ---- doc/src/angle_quartic.rst | 41 +++++++++--------- doc/txt/angle_quartic.txt | 77 ---------------------------------- 4 files changed, 19 insertions(+), 108 deletions(-) delete mode 100644 doc/src/Eqs/angle_quartic.jpg delete mode 100644 doc/src/Eqs/angle_quartic.tex delete mode 100644 doc/txt/angle_quartic.txt diff --git a/doc/src/Eqs/angle_quartic.jpg b/doc/src/Eqs/angle_quartic.jpg deleted file mode 100644 index 744ce7a35ff5dcc4aa7079bc5234574762939fa3..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5273 zcmb`LS5OlSvxb9okQSOs#{>)z{fLN2RX~BzF@T2Rr+`Qa5JY+xq=*ngXd+D#5HNH| zD2h^q&2IU7Cu1>lB1(0c%&qoV`po;%=d z0-yz8q-S7Ypl3V}jEsy-%okah&y9_I}1RYZl8{h2XNK`5C+fz=+7n2MgGsu$1>2=9(({dAN>;`d+_l&*p08 zR)(-JcJj1)7lP8(Z*E1JDSiY7U;t8|y$CX5kPh^ug`||dPn!3q)u~L}FHIG0)n0d) z#)%9zrwEP>os z`%@I0H(lT2d?MPO%`;Z2P%!vrpsZ7ibSt}q?W^gE(Jl)-HhAiWz=^KCp`V_oX6z-0 z{FK!ajG}K%D1r#k>swQKzhB)OqElr>puGDB!ev*E!~jt_f`&ua+oMHK4z&wGa^()ufM+#`K!|A zqfOBAMP{L3p_K%1)Wg;vDGCqT`tXFi@h#VQ5UQ*49a~+BJLxi$0~g1C7e*lQ@+7G; z5R+NWB%H$T!Hq|0q=5={hEw5YdE4wi^TbFpa{*+XFb-+B-yT{sfOqoPo8b)LyxF=P z7;-JTFl}!NOjUkGvb)nQa!@i?zO8Xs;_}=j#s+prX`x<%1g~#3OOzBcW>oGs+UHB0 z^b=DqLj+MbfYUGr=|CNaUZ3XpPQ7^o-A@|o!N!=&u0&|w zf{fX49zGWWNWPZ!T^#7L@P7Hi7W*`mO1~B*KurK9OS~|J_u(;Yh~x`wx(qy1^$<8h zjU-)e?WQ@+`76~PdL2@lc#n%|5IBRfN571XX8UCnvr&{*!gBiswxkkuS81?4kZ;bY z;J#sTptbQKM%QF?4<6Rf&zd^9VR2MayHV45>s>UPpU)knN4jwQ`^_WJ7OQZKNH1pS z)$Yo=PvgHS`a{PWlvioKwtF(!KJJ%HGn zMHvHx?BCa(P0xZPr)oSe-9IUF1y=I+{W6MXCavNczs z9%Np%4U~Pg?sQ6;Jy3GfwPAZu=qbj_#^WzvLc!z_fK@H*lW5{R?{>+Dv2CG`m$fO~ zkT$b+30BoXh0KFKfZtFNuJpHUieuW(dfAl`GuY*d%kii4O%5$ueuF1?fj=g_h^x81f6KYjVSlYns$n+ea*38(dy3lW(`tpCXg@~O8*gTT zj=O)aZ4kGHn_8O&P+?A?lS1~2&mOo3BAw_U44Fw2T}c(j>C(^Zir!M0?@y_n0d9CC z*ZVYdpa^1}0 zsWmRvQ*=fQbNtO;k6CD^XEL|_?$GS3eVYz}JV`@Q5}@U0fR9PYNXTPm+wDu73uz%n zzq{OS)on>o4hV(X^lbmIT`WGb@ycah!Q`$!$q>+CmfR;?EAP}M3#>t%uyfj*`aNB) zxy&@+c*0WAsB=sZ+QO}J4x0{^n>VqaAV{}Ehk579O7ol4=7V%Cw+BU$w4j%iDNEYI z!&$3&UI(j@N0c}bV|#;FU#$moyv?#ZR8~{b#nhrNa@nxCxUNKHeXPj+kpu=i)PkR8O4ESVV(SL*Gr)^547p`tWg ztTvpt2YOE{x(;0WvL_Auss!(M3CiGu9!XqtAWcC|3fr0xL4ka)51n(x zOX74$Ps=A>yP;Y|uNwxb;?;=3psTO7mMQ*!%)x6DUV`oE>&ua;;s)K)GVB@S)($KV zWmTuKn7q?fOM)zPA4?f>Y=x$+IW00Y>>SZ-oC~@}})y4SCqwi$=R1O;?@hP6NS*;*eg!biWpSB&Y@m(8%!L`?DL{ z>EBlO%Bjj8NPi%}{X3?BJq%yi3aP2hZk@^1a}RE~ZBbV=!@HUL=2NDQa(7bsl(l4+=k!;_9x0*eMBk_-7~v_k2QU^V1^JQDnk^wh;5^@?=3 zt+$;6i-t$aV90%oX1F<5=~&X?4LEIt%qYh9NL%HFWg>R_H7dIiSYq!V@xFUUHs!W+ zo4-x?Ea^GzCXS=m5CW)=0`PKb&P^xXiAs0S?(D? zS58vXc+3FW7o_rf`QZ_N?y}ifUAg+o#MTw$;{g7dEPthwpXC_7)?cKsxpVSv0y@5rpHNQ>W{nMQHMtH_lv(?iIzsu+|#i?LB_m1GzK6-^Cvx0~=?6hSC?NHxUL-4?QmiEq(vDZbDHf z1DUh}%!AyMrkRDn%Pbf%w(_nA<57I!ZZ&TsvqdV~(>hLPsw*V}R`s2n)OKg75j%ZT zjmU#l#;KnJ=PxgJL*ZZ;>9%v(TYpaYt9_fyVhc8L9(SjVkZm-L9Cq(_nEr?qbgXN; zU+bAD`3!@|y)J?B*K*Me6Ea0vhxN0HhqE$OQ%P=|3+ah(r4Vs?wWi~hMOsB3z7*FO zTVQInfaW3HB>tKb@2F+LJ)oV};rQg0;0d4FWI zPMmf>{_IU2cCoWqitl-q5*up{bD{oJ0cF;0B0XA;8>Jb}q0mC&s4W9=2eYLw|{7~5^ywSH>4fSk)y<@Kjt}11Ixtb}>D=CLS z{+NC7V3a0XFz#<)0Q2S;^fgi#JYnqpIl|F+h$U_SVmNZ?>tc2IImeA(?h-9#k)36G zA6{NPcwPYV6}%>+9|>U>CTAXD_%e^ejXxD-G3=ZHzQo1eH0~x@nYzY4s_aHPqupNm zw4_9Q!lblcb6-#!3`funA0L|~@q$+P%liv5CN|81`{LxTW!KG}mr(GKTIXubcck+TaAA-pPFT1@u55M}-T=t=dy#Xj+%a@uu$k zfNRS937Y8L8>>M2`AEyK-CvnLFlJ2=r%I=e=Yr9d+HY9T+#D3Gc{4bGLH|Y_c8C}! zaYQN=f~EW0s?4}N-%vvoBf6sSvzD~?w*|bGFYF($AHe=3*KdHD(Z812O{vZAIOnzt zwK|b$tMH4Td^4-R_)@n!pJj*^d<&RLEiI*pIPNkWJC{~{(*G)tsxw5?!rW2h96AH5 z$@cF3zYj9u_fA&7n3kz3_wAbxGL77nq>GEp?=!{p>Rp}j;NRiilu^`KY!4K_~@M zcjD`(51nRlJ{C3n6R$?r@3@gPm*!Ppi}_ExXT%x2dsVgx(RWiCn+^}v;I?w`*WFo1 zs*9zKRs_n&6)_A4wW6D;isj^jP-NflLj)$^^+%b~gx-3}>gOt>LNEE&_TQcmmHx7IZ% zXpW;seLP%u7LD~tkgr6wuVFU&c-dZ#NFnvZzI_seaDNzOctLLJ`>2wQ%M|@t&sG|| zF5kN&*L&*deFk{>P^m{A)rL6E(fgwMgq8g;a>aTbJw-lgE}mKRX|r1YvShAN>fNuX z&a0?NwpxE2$hwnagq?8W1k0H2>b^n&jh`-hF|AUTqGVSh0w)s$MO$*(4T(-BbBZpM zfu5Y>nl}S8k$(J8|37LgHTCOM!3Y1ieXRFL+gn*i*VK9-vmc`t^L63EF3mC!R=CX( zfIbGUI}$XlmW#3XvXdg^*+PHFpt?4O#yG(dT($GF0sce#{|g{w8nef4T;^0Qwt4?o z&W*gH-kchAMt8SV|JD2Z*|2Q&sXm*EU9;Wcrf+g^%?qj~T<@(lxs&N8A*{-(xQBM<)B_<9 z5ZBzf_1ODz2@%&|g)YD-=G&m0&?La#Y!zsA1i4qr{`{7>Lo=kIH$icBkp99y34CP} zP^gnt6dXx0!@W7#xGN4&rJUGRQeMhr<9=Fkbf6QNc!iGw8tgxP!s@uW$-*rf!mY$` zNp=L;lo7W`mpF3Y)qEA%pk+3=&&Ro*!V&)IA$=q+c(JY!9^JW?T_xZi6;mMrgI!TmrrjuT(b1>2680;@v00LI1@bii@x!nYRz?>Y zBo5~@3IG8V_0)G)*ZW*_f=y=~+uRlFmO|gdI-C{U_ZYeUCVt3ELS8Q8z3avZ#HY zzfqj9n%anyK}+95qU-)V8+TRG1XcmAiMtTQ`>S5I*U^(s6_{ bV}-_^gxuO3vCkY`{;$%s|38=uIUD;Qp^F_J diff --git a/doc/src/Eqs/angle_quartic.tex b/doc/src/Eqs/angle_quartic.tex deleted file mode 100644 index ff9ff9a7dc..0000000000 --- a/doc/src/Eqs/angle_quartic.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4 (\theta - \theta_0)^4 -$$ - -\end{document} diff --git a/doc/src/angle_quartic.rst b/doc/src/angle_quartic.rst index 88773bbca8..104c0be802 100644 --- a/doc/src/angle_quartic.rst +++ b/doc/src/angle_quartic.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style quartic +.. index:: angle_style quartic -angle\_style quartic command -============================ +angle_style quartic command +=========================== -angle\_style quartic/omp command -================================ +angle_style quartic/omp command +=============================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style quartic @@ -18,7 +18,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style quartic angle_coeff 1 129.1948 56.8726 -25.9442 -14.2221 @@ -28,24 +28,26 @@ Description The *quartic* angle style uses the potential -.. image:: Eqs/angle_quartic.jpg - :align: center +.. math:: -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. + E = K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4 (\theta - \theta_0)^4 + + +where :math:`\theta_0` is the equilibrium value of the angle, and :math:`K` is a +prefactor. Note that the usual 1/2 factor is included in :math:`K`. The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* theta0 (degrees) -* K2 (energy/radian\^2) -* K3 (energy/radian\^3) -* K4 (energy/radian\^4) +* :math:`\theta_0` (degrees) +* :math:`K_2` (energy/radian\^2) +* :math:`K_3` (energy/radian\^3) +* :math:`K_4` (energy/radian\^4) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian\^2. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K` are in energy/radian\^2. ---------- @@ -87,8 +89,3 @@ Related commands :doc:`angle\_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_quartic.txt b/doc/txt/angle_quartic.txt deleted file mode 100644 index b20a06eb8d..0000000000 --- a/doc/txt/angle_quartic.txt +++ /dev/null @@ -1,77 +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 - -angle_style quartic command :h3 -angle_style quartic/omp command :h3 - -[Syntax:] - -angle_style quartic :pre - -[Examples:] - -angle_style quartic -angle_coeff 1 129.1948 56.8726 -25.9442 -14.2221 :pre - -[Description:] - -The {quartic} angle style uses the potential - -:c,image(Eqs/angle_quartic.jpg) - -where theta0 is the equilibrium value of the angle, and K is a -prefactor. Note that the usual 1/2 factor is included in K. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -theta0 (degrees) -K2 (energy/radian^2) -K3 (energy/radian^3) -K4 (energy/radian^4) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian^2. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER_MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From cbbe449d07a051cb870efd9600e474d99f151623 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 15:59:06 +0000 Subject: [PATCH 422/557] Updated README --- src/USER-CGDNA/README | 74 +++++++++++++++++++++++++------------------ 1 file changed, 44 insertions(+), 30 deletions(-) diff --git a/src/USER-CGDNA/README b/src/USER-CGDNA/README index 48d6178d13..a57168e53e 100644 --- a/src/USER-CGDNA/README +++ b/src/USER-CGDNA/README @@ -2,12 +2,12 @@ This package contains a LAMMPS implementation of coarse-grained models of DNA, which can be used to model sequence-specific DNA strands. -Please cite [1] and the relevant oxDNA articles in any publication -that uses this package. +Please cite [1] and the relevant oxDNA, oxDNA2 and oxRNA2 articles +in any publication that uses this package. -See the doc pages and [2,3,4] for the individual bond and pair styles. +See the doc pages and [2,3,4,5,6] for the individual bond and pair styles. The packages contains also a new Langevin-type rigid-body integrator, -which has also its own doc page and is explained in [5]. +which has also its own doc page and is explained in [7]. [1] O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, "Coarse-grained simulation of DNA using LAMMPS", @@ -17,24 +17,31 @@ Eur. Phys. J. E 41, 57 (2018). and thermodynamic properties of a coarse-grained DNA model", J. Chem. Phys. 134, 085101 (2011). -[3] T.E. Ouldridge, Coarse-grained modelling of DNA and DNA -self-assembly, DPhil. University of Oxford (2011). +[3] T.E. Ouldridge, "Coarse-grained modelling of DNA and DNA +self-assembly", DPhil. University of Oxford (2011). -[4] B.E. Snodin, F. Randisi, M. Mosayebi, et al., Introducing -Improved Structural Properties and Salt Dependence into a Coarse-Grained -Model of DNA, J. Chem. Phys. 142, 234901 (2015). +[4] B.E. Snodin, F. Randisi, M. Mosayebi, et al., "Introducing +Improved structural properties and salt dependence into a coarse-grained +model of DNA", J. Chem. Phys. 142, 234901 (2015). -[5] R. Davidchack, T. Ouldridge, M. Tretyakov, "New Langevin and +[5] P. Sulc, F. Romano, T.E. Ouldridge, et al., "A nucleotide-level +coarse-grained model of RNA", J. Chem. Phys. 140, 235102 (2014). + +[6] P. Sulc, F. Romano, T.E. Ouldridge, et al., "Sequence-dependent +thermodynamics of a coarse-grained DNA model", +J. Chem. Phys. 137, 135101 (2012). + +[7] R. Davidchack, T. Ouldridge, M. Tretyakov, "New Langevin and gradient thermostats for rigid body dynamics", J. Chem. Phys. 142, 144114 (2015). Example input and data files can be found in -/examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. Python setup -tools which create single straight or helical DNA strands as -well as DNA duplexes or arrays of duplexes can be found in -/examples/USER/cgdna/util/. A technical report with more information -on the models, the structure of the input and data file, the setup tool -and the performance of the LAMMPS-implementation of oxDNA can be found +/examples/USER/cgdna/examples/oxDNA/, /oxDNA2/ and /oxRNA2/. +Python setup tools which create single straight or helical DNA or RNA +strands as well as DNA or RNA duplexes or arrays of duplexes can be +found in /examples/USER/cgdna/util/. A technical report with more +general information on the model, its implementation and performance +as well as the structure of the data and input file can be found in /doc/src/PDF/USER-CGDNA.pdf. IMPORTANT NOTE: This package can only be used if LAMMPS is compiled @@ -54,34 +61,41 @@ oliver d o t henrich a t strath d o t ac d o t uk ** Bond styles provided by this package: -bond_oxdna_fene.cpp: backbone connectivity, a modified FENE potential +bond_oxdna_fene.cpp: backbone connectivity, + a modified FENE potential (see [2,3]) -bond_oxdna2_fene.cpp: corresponding bond style in oxDNA2 (see [3]) +bond_oxdna2_fene.cpp: corresponding bond style in oxDNA2 (see [4]) + +bond_oxrna2_fene.cpp: corresponding bond style in oxRNA2 (see [5]) ** Pair styles provided by this package: -pair_oxdna_excv.cpp: excluded volume interaction between the nucleotides +pair_oxdna_excv.cpp: excluded volume interaction between the nucleotides -pair_oxdna_stk.cpp: stacking interaction between consecutive nucleotides - on the same strand +pair_oxdna_stk.cpp: stacking interaction between consecutive nucleotides + on the same strand -pair_oxdna_hbond.cpp: hydrogen-bonding interaction between complementary - nucleotides on different strands, e.g. A-T and C-G +pair_oxdna_hbond.cpp: hydrogen-bonding interaction between complementary + nucleotides on different strands, e.g. A-T and C-G -pair_oxdna_xstk.cpp: cross-stacking interaction between nucleotides +pair_oxdna_xstk.cpp: cross-stacking interaction between nucleotides -pair_oxdna_coaxstk.cpp: coaxial stacking interaction between nucleotides +pair_oxdna_coaxstk.cpp: coaxial stacking interaction between nucleotides +pair_oxdna2_excv.cpp, pair_oxdna2_coaxstk.cpp: + corresponding pair styles in oxDNA2 (see [4]) -pair_oxdna2_excv.cpp, pair_oxdna2_coaxstk.cpp: - corresponding pair styles in oxDNA2 (see [3]) +pair_oxrna2_excv.cpp, pair_oxrna2_stk.cpp, pair_oxrna2_hbond.cpp, +pair_oxrna2_xstk.cpp: + corresponding pair styles in oxDNA2 (see [5]) + +pair_oxdna2_dh.cpp, pair_oxrna2_dh.cpp: + Debye-Hueckel electrostatic interaction between backbone sites -pair_oxdna2_dh.cpp: Debye-Hueckel electrostatic interaction between backbone - sites ** Fixes provided by this package: fix_nve_dotc_langevin.cpp: fix for Langevin-type rigid body integrator "C" - in above Ref. [3] + in above Ref. [7] fix_nve_dot.cpp: NVE-type rigid body integrator without noise From a20a27880d0f8577638e37237426d536aad8442d Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:05:23 -0500 Subject: [PATCH 423/557] Update docs: angle_sdk --- doc/src/angle_sdk.rst | 37 +++++++++---------- doc/txt/angle_sdk.txt | 83 ------------------------------------------- 2 files changed, 17 insertions(+), 103 deletions(-) delete mode 100644 doc/txt/angle_sdk.txt diff --git a/doc/src/angle_sdk.rst b/doc/src/angle_sdk.rst index 01342ad8d4..0af22a5372 100644 --- a/doc/src/angle_sdk.rst +++ b/doc/src/angle_sdk.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style sdk +.. index:: angle_style sdk -angle\_style sdk command -======================== +angle_style sdk command +======================= -angle\_style sdk/omp command -============================ +angle_style sdk/omp command +=========================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style sdk @@ -20,7 +20,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style sdk angle_coeff 1 300.0 107.0 @@ -30,25 +30,27 @@ Description The *sdk* angle style is a combination of the harmonic angle potential, -.. image:: Eqs/angle_harmonic.jpg - :align: center +.. math:: -where theta0 is the equilibrium value of the angle and K a prefactor, + E = K (\theta - \theta_0)^2 + + +where :math:`\theta_0` is the equilibrium value of the angle and :math:`K` a prefactor, with the *repulsive* part of the non-bonded *lj/sdk* pair style between the atoms 1 and 3. This angle potential is intended for coarse grained MD simulations with the CMM parameterization using the :doc:`pair\_style lj/sdk `. Relative to the pair\_style *lj/sdk*\ , however, the energy is shifted by *epsilon*\ , to avoid sudden -jumps. Note that the usual 1/2 factor is included in K. +jumps. Note that the usual 1/2 factor is included in :math:`K`. The following coefficients must be defined for each angle type via the :doc:`angle\_coeff ` command as in the example above: -* K (energy/radian\^2) -* theta0 (degrees) +* :math:`K` (energy/radian\^2) +* :math:`\theta_0` (degrees) -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian\^2. +:math:`\theta_0` is specified in degrees, but LAMMPS converts it to radians +internally; hence the units of :math:`K` are in energy/radian\^2. The also required *lj/sdk* parameters will be extracted automatically from the pair\_style. @@ -93,8 +95,3 @@ Related commands :doc:`pair\_style lj/sdk/coul/long ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_sdk.txt b/doc/txt/angle_sdk.txt deleted file mode 100644 index 9382d560d3..0000000000 --- a/doc/txt/angle_sdk.txt +++ /dev/null @@ -1,83 +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 - -angle_style sdk command :h3 -angle_style sdk/omp command :h3 - -[Syntax:] - -angle_style sdk :pre -angle_style sdk/omp :pre - -[Examples:] - -angle_style sdk -angle_coeff 1 300.0 107.0 :pre - -[Description:] - -The {sdk} angle style is a combination of the harmonic angle potential, - -:c,image(Eqs/angle_harmonic.jpg) - -where theta0 is the equilibrium value of the angle and K a prefactor, -with the {repulsive} part of the non-bonded {lj/sdk} pair style -between the atoms 1 and 3. This angle potential is intended for -coarse grained MD simulations with the CMM parameterization using the -"pair_style lj/sdk"_pair_sdk.html. Relative to the pair_style -{lj/sdk}, however, the energy is shifted by {epsilon}, to avoid sudden -jumps. Note that the usual 1/2 factor is included in K. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above: - -K (energy/radian^2) -theta0 (degrees) :ul - -Theta0 is specified in degrees, but LAMMPS converts it to radians -internally; hence the units of K are in energy/radian^2. -The also required {lj/sdk} parameters will be extracted automatically -from the pair_style. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This angle style can only be used if LAMMPS was built with the -USER-CGSDK package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html, "angle_style -harmonic"_angle_harmonic.html, "pair_style lj/sdk"_pair_sdk.html, -"pair_style lj/sdk/coul/long"_pair_sdk.html - -[Default:] none From e017e7d447a891ae38d6837147f0a8450e31fc63 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:13:07 -0500 Subject: [PATCH 424/557] Update docs: angle_zero --- doc/src/angle_zero.rst | 27 ++++++++++------------- doc/txt/angle_zero.txt | 49 ------------------------------------------ 2 files changed, 11 insertions(+), 65 deletions(-) delete mode 100644 doc/txt/angle_zero.txt diff --git a/doc/src/angle_zero.rst b/doc/src/angle_zero.rst index e6b485bc95..e5dab4e3a0 100644 --- a/doc/src/angle_zero.rst +++ b/doc/src/angle_zero.rst @@ -1,13 +1,13 @@ -.. index:: angle\_style zero +.. index:: angle_style zero -angle\_style zero command -========================= +angle_style zero command +======================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style zero *nocoeff* @@ -15,12 +15,12 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style zero angle_style zero nocoeff - angle_coeff \* - angle_coeff \* 120.0 + angle_coeff * + angle_coeff * 120.0 Description """"""""""" @@ -32,14 +32,14 @@ other commands. As an example, the :doc:`compute angle/local ` command can be used to compute the theta values for the list of triplets of angle atoms listed in the data file read by the -:doc:`read\_data ` command. If no angle style is defined, +:doc:`read_data ` command. If no angle style is defined, this command cannot be used. The optional *nocoeff* flag allows to read data files with AngleCoeff -section for any angle style. Similarly, any angle\_coeff commands +section for any angle style. Similarly, any :doc:`angle_coeff ` commands will only be checked for the angle type number and the rest ignored. -Note that the :doc:`angle\_coeff ` command must be used for +Note that the :doc:`angle_coeff ` command must be used for all angle types. If specified, there can be only one value, which is going to be used to assign an equilibrium angle, e.g. for use with :doc:`fix shake `. @@ -51,11 +51,6 @@ Restrictions Related commands """""""""""""""" -:doc:`angle\_style none ` +:doc:`angle_style none ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_zero.txt b/doc/txt/angle_zero.txt deleted file mode 100644 index c6c1958ec8..0000000000 --- a/doc/txt/angle_zero.txt +++ /dev/null @@ -1,49 +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 - -angle_style zero command :h3 - -[Syntax:] - -angle_style zero {nocoeff} :pre - -[Examples:] - -angle_style zero -angle_style zero nocoeff -angle_coeff * -angle_coeff * 120.0 :pre - -[Description:] - -Using an angle style of zero means angle forces and energies are not -computed, but the geometry of angle triplets is still accessible to -other commands. - -As an example, the "compute angle/local"_compute_angle_local.html -command can be used to compute the theta values for the list of -triplets of angle atoms listed in the data file read by the -"read_data"_read_data.html command. If no angle style is defined, -this command cannot be used. - -The optional {nocoeff} flag allows to read data files with AngleCoeff -section for any angle style. Similarly, any angle_coeff commands -will only be checked for the angle type number and the rest ignored. - -Note that the "angle_coeff"_angle_coeff.html command must be used for -all angle types. If specified, there can be only one value, which is -going to be used to assign an equilibrium angle, e.g. for use with -"fix shake"_fix_shake.html. - -[Restrictions:] none - -[Related commands:] - -"angle_style none"_angle_none.html - -[Default:] none From fb64068fbcbfaf5e931d5c7fbb032eacbc08c356 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:16:47 -0500 Subject: [PATCH 425/557] Update docs: angle_coeff --- doc/src/angle_coeff.rst | 41 +++++++++---------- doc/txt/angle_coeff.txt | 87 ----------------------------------------- 2 files changed, 18 insertions(+), 110 deletions(-) delete mode 100644 doc/txt/angle_coeff.txt diff --git a/doc/src/angle_coeff.rst b/doc/src/angle_coeff.rst index 1e54f69051..5f9a71371a 100644 --- a/doc/src/angle_coeff.rst +++ b/doc/src/angle_coeff.rst @@ -1,13 +1,13 @@ -.. index:: angle\_coeff +.. index:: angle_coeff -angle\_coeff command -==================== +angle_coeff command +=================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_coeff N args @@ -18,11 +18,11 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_coeff 1 300.0 107.0 - angle_coeff \* 5.0 - angle_coeff 2\*10 5.0 + angle_coeff * 5.0 + angle_coeff 2*10 5.0 Description """"""""""" @@ -30,7 +30,7 @@ Description Specify the angle force field coefficients for one or more angle types. The number and meaning of the coefficients depends on the angle style. Angle coefficients can also be set in the data file read by the -:doc:`read\_data ` command or in a restart file. +:doc:`read_data ` command or in a restart file. N can be specified in one of two ways. An explicit numeric value can be used, as in the 1st example above. Or a wild-card asterisk can be @@ -41,18 +41,18 @@ leading asterisk means all types from 1 to n (inclusive). A trailing asterisk means all types from n to N (inclusive). A middle asterisk means all types from m to n (inclusive). -Note that using an angle\_coeff command can override a previous setting +Note that using an :doc:`angle_coeff ` command can override a previous setting for the same angle type. For example, these commands set the coeffs for all angle types, then overwrite the coeffs for just angle type 2: -.. parsed-literal:: +.. code-block:: LAMMPS - angle_coeff \* 200.0 107.0 1.2 + angle_coeff * 200.0 107.0 1.2 angle_coeff 2 50.0 107.0 A line in a data file that specifies angle coefficients uses the exact -same format as the arguments of the angle\_coeff command in an input +same format as the arguments of the :doc:`angle_coeff ` command in an input script, except that wild-card asterisks should not be used since coefficients for all N types must be listed in the file. For example, under the "Angle Coeffs" section of a data file, the line that @@ -63,7 +63,7 @@ corresponds to the 1st example above would be listed as 1 300.0 107.0 -The :doc:`angle\_style class2 ` is an exception to this +The :doc:`angle_style class2 ` is an exception to this rule, in that an additional argument is used in the input script to allow specification of the cross-term coefficients. See its doc page for details. @@ -73,13 +73,13 @@ doc page for details. The list of all angle styles defined in LAMMPS is given on the -:doc:`angle\_style ` doc page. They are also listed in more +:doc:`angle_style ` doc page. They are also listed in more compact form on the :ref:`Commands angle ` doc page. On either of those pages, click on the style to display the formula it computes and its coefficients as specified by the associated -angle\_coeff command. +:doc:`angle_coeff ` command. ---------- @@ -90,8 +90,8 @@ Restrictions This command must come after the simulation box is defined by a -:doc:`read\_data `, :doc:`read\_restart `, or -:doc:`create\_box ` command. +:doc:`read_data `, :doc:`read_restart `, or +:doc:`create_box ` command. An angle style must be defined before any angle coefficients are set, either in the input script or in a data file. @@ -99,11 +99,6 @@ set, either in the input script or in a data file. Related commands """""""""""""""" -:doc:`angle\_style ` +:doc:`angle_style ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_coeff.txt b/doc/txt/angle_coeff.txt deleted file mode 100644 index 5dc9c13381..0000000000 --- a/doc/txt/angle_coeff.txt +++ /dev/null @@ -1,87 +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 - -angle_coeff command :h3 - -[Syntax:] - -angle_coeff N args :pre - -N = angle type (see asterisk form below) -args = coefficients for one or more angle types :ul - -[Examples:] - -angle_coeff 1 300.0 107.0 -angle_coeff * 5.0 -angle_coeff 2*10 5.0 :pre - -[Description:] - -Specify the angle force field coefficients for one or more angle types. -The number and meaning of the coefficients depends on the angle style. -Angle coefficients can also be set in the data file read by the -"read_data"_read_data.html command or in a restart file. - -N can be specified in one of two ways. An explicit numeric value can -be used, as in the 1st example above. Or a wild-card asterisk can be -used to set the coefficients for multiple angle types. This takes the -form "*" or "*n" or "n*" or "m*n". If N = the number of angle types, -then an asterisk with no numeric values means all types from 1 to N. A -leading asterisk means all types from 1 to n (inclusive). A trailing -asterisk means all types from n to N (inclusive). A middle asterisk -means all types from m to n (inclusive). - -Note that using an angle_coeff command can override a previous setting -for the same angle type. For example, these commands set the coeffs -for all angle types, then overwrite the coeffs for just angle type 2: - -angle_coeff * 200.0 107.0 1.2 -angle_coeff 2 50.0 107.0 :pre - -A line in a data file that specifies angle coefficients uses the exact -same format as the arguments of the angle_coeff command in an input -script, except that wild-card asterisks should not be used since -coefficients for all N types must be listed in the file. For example, -under the "Angle Coeffs" section of a data file, the line that -corresponds to the 1st example above would be listed as - -1 300.0 107.0 :pre - -The "angle_style class2"_angle_class2.html is an exception to this -rule, in that an additional argument is used in the input script to -allow specification of the cross-term coefficients. See its -doc page for details. - -:line - -The list of all angle styles defined in LAMMPS is given on the -"angle_style"_angle_style.html doc page. They are also listed in more -compact form on the "Commands angle"_Commands_bond.html#angle doc -page. - -On either of those pages, click on the style to display the formula it -computes and its coefficients as specified by the associated -angle_coeff command. - -:line - -[Restrictions:] - -This command must come after the simulation box is defined by a -"read_data"_read_data.html, "read_restart"_read_restart.html, or -"create_box"_create_box.html command. - -An angle style must be defined before any angle coefficients are -set, either in the input script or in a data file. - -[Related commands:] - -"angle_style"_angle_style.html - -[Default:] none From cdd56cd08f137de0fdc3bcfa8b60ffd44c51064c Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:22:25 -0500 Subject: [PATCH 426/557] Update docs: angle_style --- doc/src/angle_style.rst | 33 +++++------- doc/txt/angle_style.txt | 112 ---------------------------------------- 2 files changed, 14 insertions(+), 131 deletions(-) delete mode 100644 doc/txt/angle_style.txt diff --git a/doc/src/angle_style.rst b/doc/src/angle_style.rst index 6d7c70565b..3e22113d85 100644 --- a/doc/src/angle_style.rst +++ b/doc/src/angle_style.rst @@ -1,13 +1,13 @@ -.. index:: angle\_style +.. index:: angle_style -angle\_style command -==================== +angle_style command +=================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style style @@ -17,7 +17,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style harmonic angle_style charmm @@ -29,19 +29,19 @@ Description Set the formula(s) LAMMPS uses to compute angle interactions between triplets of atoms, which remain in force for the duration of the simulation. The list of angle triplets is read in by a -:doc:`read\_data ` or :doc:`read\_restart ` command +:doc:`read_data ` or :doc:`read_restart ` command from a data or restart file. Hybrid models where angles are computed using different angle potentials can be setup using the *hybrid* angle style. The coefficients associated with a angle style can be specified in a -data or restart file or via the :doc:`angle\_coeff ` command. +data or restart file or via the :doc:`angle_coeff ` command. All angle potentials store their coefficient data in binary restart -files which means angle\_style and :doc:`angle\_coeff ` +files which means angle_style and :doc:`angle_coeff ` commands do not need to be re-specified in an input script that -restarts a simulation. See the :doc:`read\_restart ` +restarts a simulation. See the :doc:`read_restart ` command for details on how to do this. The one exception is that angle\_style *hybrid* only stores the list of sub-styles in the restart file; angle coefficients need to be re-specified. @@ -49,7 +49,7 @@ file; angle coefficients need to be re-specified. .. note:: When both an angle and pair style is defined, the - :doc:`special\_bonds ` command often needs to be used to + :doc:`special_bonds ` command often needs to be used to turn off (or weight) the pairwise interaction that would otherwise exist between 3 bonded atoms. @@ -62,11 +62,11 @@ between the 3 atoms in the angle. Here is an alphabetic list of angle styles defined in LAMMPS. Click on the style to display the formula it computes and coefficients -specified by the associated :doc:`angle\_coeff ` command. +specified by the associated :doc:`angle_coeff ` command. Click on the style to display the formula it computes, any additional arguments specified in the angle\_style command, and coefficients -specified by the associated :doc:`angle\_coeff ` command. +specified by the associated :doc:`angle_coeff ` command. There are also additional accelerated pair styles included in the LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. @@ -115,17 +115,12 @@ individual bond potentials tell if it is part of a package. Related commands """""""""""""""" -:doc:`angle\_coeff ` +:doc:`angle_coeff ` Default """"""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_style.txt b/doc/txt/angle_style.txt deleted file mode 100644 index 2f2da678d8..0000000000 --- a/doc/txt/angle_style.txt +++ /dev/null @@ -1,112 +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 - -angle_style command :h3 - -[Syntax:] - -angle_style style :pre - -style = {none} or {hybrid} or {charmm} or {class2} or {cosine} or \ - {cosine/squared} or {harmonic} :ul - -[Examples:] - -angle_style harmonic -angle_style charmm -angle_style hybrid harmonic cosine :pre - -[Description:] - -Set the formula(s) LAMMPS uses to compute angle interactions between -triplets of atoms, which remain in force for the duration of the -simulation. The list of angle triplets is read in by a -"read_data"_read_data.html or "read_restart"_read_restart.html command -from a data or restart file. - -Hybrid models where angles are computed using different angle -potentials can be setup using the {hybrid} angle style. - -The coefficients associated with a angle style can be specified in a -data or restart file or via the "angle_coeff"_angle_coeff.html command. - -All angle potentials store their coefficient data in binary restart -files which means angle_style and "angle_coeff"_angle_coeff.html -commands do not need to be re-specified in an input script that -restarts a simulation. See the "read_restart"_read_restart.html -command for details on how to do this. The one exception is that -angle_style {hybrid} only stores the list of sub-styles in the restart -file; angle coefficients need to be re-specified. - -NOTE: When both an angle and pair style is defined, the -"special_bonds"_special_bonds.html command often needs to be used to -turn off (or weight) the pairwise interaction that would otherwise -exist between 3 bonded atoms. - -In the formulas listed for each angle style, {theta} is the angle -between the 3 atoms in the angle. - -:line - -Here is an alphabetic list of angle styles defined in LAMMPS. Click on -the style to display the formula it computes and coefficients -specified by the associated "angle_coeff"_angle_coeff.html command. - -Click on the style to display the formula it computes, any additional -arguments specified in the angle_style command, and coefficients -specified by the associated "angle_coeff"_angle_coeff.html command. - -There are also additional accelerated pair styles included in the -LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. -The individual style names on the "Commands -angle"_Commands_bond.html#angle doc page are followed by one or more -of (g,i,k,o,t) to indicate which accelerated styles exist. - -"none"_angle_none.html - turn off angle interactions -"zero"_angle_zero.html - topology but no interactions -"hybrid"_angle_hybrid.html - define multiple styles of angle interactions :ul - -"charmm"_angle_charmm.html - CHARMM angle -"class2"_angle_class2.html - COMPASS (class 2) angle -"class2/p6"_angle_class2.html - COMPASS (class 2) angle expanded to 6th order -"cosine"_angle_cosine.html - angle with cosine term -"cosine/buck6d"_angle_cosine_buck6d.html - same as cosine with Buckingham term between 1-3 atoms -"cosine/delta"_angle_cosine_delta.html - angle with difference of cosines -"cosine/periodic"_angle_cosine_periodic.html - DREIDING angle -"cosine/shift"_angle_cosine_shift.html - angle cosine with a shift -"cosine/shift/exp"_angle_cosine_shift_exp.html - cosine with shift and exponential term in spring constant -"cosine/squared"_angle_cosine_squared.html - angle with cosine squared term -"cross"_angle_cross.html - cross term coupling angle and bond lengths -"dipole"_angle_dipole.html - angle that controls orientation of a point dipole -"fourier"_angle_fourier.html - angle with multiple cosine terms -"fourier/simple"_angle_fourier_simple.html - angle with a single cosine term -"harmonic"_angle_harmonic.html - harmonic angle -"mm3"_angle_mm3.html - anharmonic angle -"quartic"_angle_quartic.html - angle with cubic and quartic terms -"sdk"_angle_sdk.html - harmonic angle with repulsive SDK pair style between 1-3 atoms -"table"_angle_table.html - tabulated by angle :ul - -:line - -[Restrictions:] - -Angle styles can only be set for atom_styles that allow angles to be -defined. - -Most angle styles are part of the MOLECULE package. They are only -enabled if LAMMPS was built with that package. See the "Build -package"_Build_package.html doc page for more info. The doc pages for -individual bond potentials tell if it is part of a package. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] - -angle_style none :pre From cedcc6fc50902451bd00ee61b2b4069fee7937f4 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 15 Nov 2019 09:27:02 -0700 Subject: [PATCH 427/557] Commit JT 111519 - modified documentation spin (compute and exchange) - modified compute spin for Ts --- .../Eqs/pair_spin_exchange_interaction.jpg | Bin 5940 -> 5554 bytes .../Eqs/pair_spin_exchange_interaction.tex | 8 ++++++-- doc/src/compute_spin.txt | 16 +++++++--------- doc/src/pair_spin_exchange.txt | 5 +++-- src/SPIN/compute_spin.cpp | 3 ++- 5 files changed, 18 insertions(+), 14 deletions(-) diff --git a/doc/src/Eqs/pair_spin_exchange_interaction.jpg b/doc/src/Eqs/pair_spin_exchange_interaction.jpg index c70d8a6554003e37472d648c1944a13ee9d3f859..269be6c155cb006c07035f8b8f4f357ccb2eaf10 100644 GIT binary patch literal 5554 zcmb6-cRZY1)6W)G&n~OC)l1YwyXxvCSUsX7SOkfl2zez4q9h1n2@)l`D2pJ`S1(aR zNJ#V&lBm&nSMHbl-TVIWe!p*?`905>IWu$4@0>X^bDq=j(`f*%r=_a}fIuLii}(Pi zp8$0L0tTNU5uijQAtNDyLP;oKFj6uq3Mwi}3Q9_98d^9t4T6S}63zfe&>`vR>8Z{! zGBF^TXp!{DGb11fQ3pywPC`PCq^6`s{=ear03gT!8;}|VgaE(@5Cj1_Z3EZ<5CDdp zP4_P#A%#F;U=SIx7x{Pop8}^J0V)Vl2M&P)0O;7{7ng+;zl{6Kz^?|HZF*H}`X4+n zw9DWh4AAt^$J-+DF#+2}I-b`5f{=kf9g~{KAGTA>mf# zvb0`+3??*%jzn>78eHTc(6`{&XQjHYb1b6^_#|f1=4I(}^+w5)g>o75^%{qDq3N-? zticOTwS(u|o1?{@%sMc%0A!{&HV1^^iOWro<$g!#Fz@4^aXcT9*nNw{W?hpmth*Wn z^_Pu80RUTYBQwR&@-jN=Jjrw%pFS@rIGIm1>^(19x+lO>hB#9I;H2>i0Ge2X&)UBM z!hB7{$)+m!H+}X6&1Wa(dM%^>&I3R+9)D?`?T82*0E58*gp`!H%)bCi0wD!~0XPzd zprw;AqGw=4aiO_+c=?HYK}Osm5D9pvUq+e`JnnqMqB6Yvq;KgE_SLUYp2}T~ZX(J& z!SaIPMcantAjXi}JNpdR_`5rXuGBi4PcwbR_?71!JEsNM8Fe{Ni11yIS&i#Z5*rbE zwS%Wu;crij{3l-4nGPM~6a1+=z;U-HZ8q~(V$D*1<>@FyotNg^MCM{YYdWw<*2 z$i2QNcqOi%M4)ImIfJRX;a%ADNFR?s`PS}u2Dya}Ug>U=Oj}k>?Ub&$Pn9wmk?-i) ziiVcfDi~`)V{0d6^`ixHA0<8GxgJq7^o-JtLRT%uweJw~+*MznU_&wyG^=7lrl^w})^y^Dw$J z>9_7L%b+q~8lWFoH(QW@8=uIQ5kH+&XE*AZEJh~cH^z?X!SjB$4>*GBds)G0QZ&~? zm+O2K#*AuAq!cXaS037CW?o@es`@Fp&r;y5(7^skH9O7{i=uWuAC)zj;v>`j5M6D5 zk^A_%%G1GReNn1~52nzd!nbp0OnT&YV*E2bqD9=r5dx=L7G_m8>&)l`&56 zCR$=G9bv5LyLNt%7au14KCrHulQqv--i)A%J08Pa=hF!%pq_-nR!@PmQ;hiA>Hg(W z!M{9*cQ{y3>N$a|KLCfS6xYo5{dNOpO(_?5scD)$uYFzsD?zY=ou3qaAj4QqkxjNq# z0xJ)U!!oSTASUbEkn?7cZQ6{y@^!YX@x6q0m_Fn`g9 zGJx5bVx4qR0VAFP|+jGk6v3JYn>9*@m)*%nTEY}$Uq(YwuhCt!X( zA{SBUD`M{fd|3fYVydcRe7i=Rxe+YFAAhnjoE%xK)mFb+)w~4m=5cLLQSh>!pSkIG zWcg7_Pir`rky);*;rSd+YRP_IE8WU?tFwP4HH-9e3UK^z^6(U>(bUu%?bQ*QbJdOH zYKS-rX&3byDt28g)Zf1#Toh|jzP5rRaS#%`@YVWQ*Kl3ospW3`#B66(i@czkS-$86 z_p}DjooiW&lr2A2ZhZOPh8T%f(oVX&u~ZRKzqsR3Q`6=N8yVZa9hiOzrN^vS$i;K+ zS%W&Vu<9AdYm?y%z9+}hH#nEv+zmr(B)@!b6e`4iM2L8G;Nv!@LRYXiz6G!f327dQ^}-!tnh~Yj^y7k2p@!Pq{Ck z&gEpyD{7j4CFRq_kteVq{cE!ZPpk9q?DQiA0`gYWWrEgY(od=jypb*zS_3zw?g$PXQJpa|6rQX0%Ps zpwx{=o-moiFF1Y{AMLz-vDKTOYU3;fiX?TF6Bb7zZPV)DX0G*C1)RLueKqsmidB-` zBCTS}nqS21(*(c0UN5N>p2CKc73LO-7vH~XygR3yp0M*^Ao&y_=2`rzV%e}y$qu#rNQMcj-na&x<6-+7Zg9%C4KqU zWQUMrZ)o%GT};cQCSLKIk;4Nr784#BtUYnPl#43rt42%~6Ve13vB^P2lS&O#KPsoM zV|{!!I@2-_<%V;^?P7O(LNj90_a8nxc=@v%rjn_&)E3Q@heIWb#BwF_=)4?iIt9Gi z>7Cpn1($XGU4J}#fk~eXf8+2_*mZlM;5kps)*(JCSrp$lWn$<0&c2BnmW2H;9W;Z^uvu4`jGLtBLU=>rh@1Rx@DO%rkkACrf z@r-lQ)+Hg=Y;A=xer$e_^LZfybqo~}|I9b&ZQJ_Vq?|*A-0px$BQ@>Mx*hGU-=V;v z(FtqyT8x?D${HS!1G$eE^n_D=QGu62Zqm_Ki<{k`GWu+hW z_!eMBqkdLJ4vzFq2+asQ5YPQ=aFR7bH^AZiNXCRImb>%ec^OBuUTVb_2dfg*H|LT^ zzs*bFGb;qknI7a?8~WEcb0oYFzRMxRsOXV<1tS@mc-`d2S+%zeb4^@|c?3cJ|F+VH1?N1w>sdIDs^8rB`p|Xk#gyy1Rh+#RoB$rzJ(g=_ed(;nWqGtDpzECx|~wl zA-;OGHpfZur3%`%DXQTMuQn2I%adp>(gr^TXgiXKjB>X-7$&qivO@}||K)#pk2O9jzvH%C zw`uVnmN2&3q@gCJ$VN7tF(Ps#C#CgTysIKBqG_uux`Zq_SiV_u2Im++FMo~c7C;j-hbdnWBS#-^1*p0~Weu7v-v!HIL@E3fLFd?GsYnGU)&_n~zv%|l$^ z=}?ZJZ%AKcK~?DtU17>j{KDgppcKAmuR#MM)Y^KKuWqFJ?^$2H770F`_T}wunX@E`FK&8Izcil0#A*EQR=A)~F&B#FM?oi#>TMLYK z)fD*g`)JiqprgatH<4TB)N*YwIzBsL-n|4?sz&+{MZhZB&LQ!z{b`D!&`}84B zZyD?yfez?y#Z|;q@z|7Xhqt|L(WiRYgx4ktCKhm%;Y3hIG9( z=T(Q+uh7$|X;sHKnUrEsFoKt;Z38h1z| zy4f&&Zc$X{GLtRA*~Gc1yn@^$hp^pT$G6JjFq0foY4T;MIAj#roTHKIAk@)l{Ib7R zrz7*595v-PLYlF=5Qpj1GOE8c|Jv>o29XKgJl#O=?e6bpn@uXrQq5{`|Hnqb!OL1I_G{=tS2Utz_@SLuRIcod%7$BxFo zSu8M8hxVedU5dy@FoeBoc|=d91G)mkw>Gp&l3_aZ`J>R8IDpnJlaQkzkKDIOsWrY| zpAJ)>*io3g2oF256KEDkTjGM1$=d1_Wn9HJct|IO_3jORd}uI*Yaz8?E0(!DKx#^k z?2yoKx^gX4FNr%$8LAw;`E(xSwzT4)>4m!TmXuopVM%$JVf>k`F(Vau9A(B!Cim{O17}*~&@&lTUa&4ILG@RcDzSzJ9+0EJ#4a6Z zFbH^}L&RTQIw)FI-e3@l7X2p){iksh?LWu*kBOZP_a|chOKpEv{lovy>iD(wTdDdq_8jkkV3?Ti19Q6b-|wY!4yRp$nP(z2oOUZHt^8BGDy=+4LOYso(Z9!H@tZSfS(7ffU$dlHTsO{n*-^OeDJa|Ru8=JyTRQ{(F_Wa=NE%VK7P z#YP%V!Me66;Xr+We8G!XMz0ZJOE1Fq3Fi~WOsHNbda8aQ=+SA&M+gO>=2cW>8+QgN z)pWiUDN+knQpC)bO7||k-ibO$6mY4}qRNrKZF^_eoq>L%v8?UR> z+%~kc8m(NC-r6#L#eH~n3gn#vazS<$E<(4g8aU;#wZ z_YKKsWa1!1HG=ns8^h{eLGbMCLYW++W7%P=%%Yk?jT@hXoO+NX(1Ns*B)#BJCc=^^ zbsfbWNwCdt{J_OO?Z6%wSDaVj79|U?kNR3MX&C=H#bOXT^@IK5j*N=0u@0a@a0eD=;pUffE=$HHKe#UDg=lhyz%7|DN5PtyZJmnCdl z)EohQ{E^+FoBnmUARwC)x@$fBoJJY87wvRHdMPMuI2kYMOPU&M%3R5nUl8Tq!d71> zX`A5TV26S#u)_ijU z0ANubZ;om`xH0Q`>hmv5&#$m&M`Rmks`VUkcIFs*ghpvG9W?;8+lW*R@{6H8Rdy!hlmy2Bi^<9tML#VT^D%9X%5x6BB|Ffna7~Lo&0VSP%##28m)vb8v7l zv2t=@&|GY24)oz5APCI|3S)r57|_fJX7vBN9kc-`dcXnX2?3!1FbV`gfetzV9smS@ zA&1NTr@`nTP&gPwPqU)`t^W&fFbOb0Xg){?5&%HIh=04m$P=QifAhaPI7SWR@mu)a z4{F?Gp!^p8?)`>`jZqzP$Z3PXWV1rhl*z zS#Czq6`wrH@FgchKIL)~00G&+%DU-^V%egAsxwnyE1-%S?$vQu^?&oq@cFBhxC?Af zHC#*u;iY%Qrd9GHRGo)$^5ti7fBDg-Njb?*0pBs=rO&;gUumMr3(d`5yc4d$iMPIv z#SLmhL(1K=EZ-lls1PMmG$?k}4S-mE_fB0t({Rh2;(VL|$sBOc@z73dF#Twt5<~fu z|L50X$ac>8&X#tTu<@OLl!pvhqYy*9>CIliw0i!`dx8IEV--1bU&&m7oS@V{|Cix# z*QAgD7z_r1p>!bFUs@=Pwu^KC9F1fbz@s=YoU+<%Lc&-%McRJR({>RA1OFl@0ev1> zUl+1#mHB#49Tlp@hS|0)J&$G-0_WjZIe*yT19$Aw5Iv!T$0W}$s7x*J2Dx8SJ^;!F z6jC)ce0IE7Ebq&X#lA6eK7ICXTiUG5C^ssXd>IyNTe%sb%2JK1iR`{FSAmK-B6xk# zsb2P?)WZ%L{<&~&H&UP6eiP%Drl_@XF%D)os|R=W&u{gs7ux-htMP6PnDTYZ**sUg zHhZBuq<2%wWIYkexGI4`rc*7`)04WE1>mt` z-w+8~J`($*!7IB4{9nDpr>4zub`5x~M20W#y63Ve3=SLiwuaE_XMDIH8n92k?*C{T zQim@K6cFM(8FBJ$l_J(OvZ&;|DhKIBvphwkIkBg36+OLYpe$Lg_~tu*-BV6cg06N1 zw{DmNMVH8@@vfck^^0zlR2mqo%}AH_&1X!~cD2A%e3%Qb7K=Ze$vrur{8Uo>w^}>yq(&gafOfXSJXhb%R>fw()ml)13hCN&Qge z&8p()8+ytyQn$(VUX?Vr+@EirHPcWZVQ;>ba`%GOh}kzY_#fiqAGF?`jg$CDC2#bk ztK9KBhY0)W&|DULD#WAOqbY8p1?kT#9(WfO;E0zost3gv73-W9YQ~549{~4X`{B&Z zO=VtXn=i$8X8urgj`v(Gtu;$EX~=vkb$_($r(^Fv#^Qs^MssJzwqn5J{c-hUzJu+C zTY{cJF+5eM4##(U5qxJd&GohWn+;A$z~gHrR*EO9jLacL_*8>8>+sTr%}z~gmZ4xr zo0)iJ7HJoc5#C67<(%YvqZ!0CE4adgD__gmP7GKa4tNiqtD|=~s)b~?B&0@v| zbi)_2yX(rv?CLKhyOO8GwtZ&C%5=& zh{N(14uC77Lw@8f(d8@eMz)&8mkK9w#x>YJSHgOt$$ll2|rzN8@NiQ*<#YEQ+ z0MFe4!AmLjmu$0T;q7Lj!`Hvl?U!qM82yA?v0>zi3%eALf$my|9=FXx*BCbINIEM;#Ql(&czQCD}rSKfW?aMrA2tp?}09NG>uFn#+$ZlzgU=dZ<<8D^(R@r;wz8-^!D{&#I%G! zZ=w{ibi$SI6B`1u6ZO;I0cYG>!~VjR_^#c7 zbs;g-{TIFK=`ISU%V_n499m?BuYcwd+xKz)6pXP1(*>M{tR?jqb#b}zV)H%o>LU=z?72%OsYLfa=vENcLQL6O9SRJL!oFGcdcrx@L z)RbLrW^QIV|52Qcd!C`CiAZ;ug~G%7Y|qg$|AE28i^lzHbC9gcDCx$!Zl|2 zy45$w@(YcHv9~93nzkUfI?^p_JR|~Rajz^1&5o68{7+SxLSJO>S1oRN+sRFf5-)Q_ zlgLTyC+}+#tjW);mzqV}2htf*ap-7C@s*h5Wd)9r;AxBNX&;rZXl+aRkc}~Pvs@GD zVp3M> zJJK&=c*1**pxI2&8M@v#w>Uf0O{!34;;Vgx_M378V*`@`gRInqkMBFpN*Z)X-taEI z((9k=K3=!(+L`*+Rr2=7`re|^#Mf(P!w5NO&d38TDW$cp&tUOSupY`yQ!$xZ9BN{NzB;15@mKhH{kQ!Epjt72a4+P>*| z0u|X5bt+Y6&ob+k)T6O5$gFpKDK>$s^X1l2jC=Pw?*q8UGmY15uNB6g$V$&t*K}Tu zt;8%UJD(zQrlGS^I0YK&C>`8S8C`w1N+u`Z$Ig9>o75w%wX>Ihf=PL2?WcYSJDXYA zP+S-#xtR#L_%lxF#n1s@dAj>*jqnH7?q4Sj*5|JMQ9_g+SfJw6%In5{t<Hv`F4=Ig7k!xvr*5Z=-F@QYIL)A3UbUJ(rbw0#B-mFIsM)h zFxT;hX-?EGelPA+^yayh`%d4=F554`Ux8Q4gYnD(AhLKPOj+i6T5oY^IDM3WZN=_4 zE$x&wvx4=bmUIYv_%V7@xJPJpwI1J6m)=**QiHl1-__LHjX`zSpQn5^H9p~VG+2u- z!c3oWYhWMsE;8P{RcEgt?@H%S{^MqdYtpHv3u;F&ZXEi$J{MT~TR+BonwlCt#XnYS zRp36-wXDt>dfJlWa^?L+7NM*oz2|$KoA`PzGA?P0D62zk%U^pa-4|!?9=gMNZ4wP! z=M8WgCf-#w7?+NEt$wV>M>O7UOJsDGTE1s0!ox0^8*1X1ZKRkbERfuEuqNeFxHeHoN(p%ET&#Akh~v5J zNhfLtG(#cG>#4A~$qV-51-m>?-uFFk$i^CbGKgO86YLA?PYITAG3gQzGtZR?ClsyD z4xDrf&%D&*MCl3JSM=rAXFyD|9`6Wr+Q#c*$3%*DHUg}&0-(V`FU8LF32JVU6D{kG zbH)E`xnJFxkgq4AcYJDUjA2PEdBmA)dJXCCWtUu$%f)!kwJA$yH0z6DQnWS`OkWRb z$mJA2#bQoaxo-CS)AHx9Ex+FY00`~oj!eg4|7T+OPd(*7kjBt|9Fc#4bp+CNpy~A3 zR2-BI2Y|J)=`=k9lua8;p@C^u95xDvrGRJv8ZW?xqfPPWARsK*n8yD}42Q6P6Ak}w zG2K`o{U7jONMq2b7I4wOh) zfL$--VozP}r&mW+_uHI;xJ16tHj2KWAb9k z@t&2M?=K>7H@@29p!{PsAv_(+k^0!B40)&Zc;j22V8q& z#6bvx6y9=Sdh*;mhb5DNwA=PJ*SUO(REV2ex0KW(#dU<*_k1igvAoj?LzAeK-Y*}T zMu#kq%5B~sX}PmScK}31XD5biOSac9JPxLBlIXv_%NCH~slN_=+<S(tp$>K zcx6Lg?fhqE!q%~c#q@achv26%xj|{aw3NnNqmALF(Kqf*4i7r8Ix)}l7MmD)H$_e^ z>qJX6IIXI8j*Ts1FB9h8@%~ zt-7h{ilR?8wfDZtrFji&turpI)*0j&Q0QuEC6RBbRULdfCTS{WBC=wJ*e&QZPG4Jm z%W4>3q!N>}yfW-ldxLtN<%;S4m%Xz)QI0JXKn-Bs*jhB0Wlb^49TyF{EdY0&k$e#a z@O3@Gfjy=3hQ+0wtZnA!^P*0zQTAl&l@&Ktz}LFgqagAKeK;MaFj#w0KGbYko98=exOh7~30Jk7t%zIYQ9TA?bRy>{ubm z%D8tTR(omh?dnlnFh*vS0$V?!-K>?KE(K9S)fQD|+o6X~aY(WK!Xk#^p#*ox>s%#V zE+bHy@uo_c;bLnMJpg6BsRGgF9n`HD6nhhq(eM1>rCV7}4DfZ%yOp{ot@Avh(-08?le-YZ!62~x#| zfpzX;?H=>!U|w4CL>!_O^s$dmJ7C4cVwUf$ajq%g>~v&XPY-*ll>}j`Rmm9qL0zQl zLJVqUtm*RLq26lB5%->jo{}99$v3bee%Oe}dpmtA$ND1IQ4$Bz;XxV%34woUzuopY zlQmOTyHDPSq@RzaaE2Orp;-2W(7EDDpqRd3btt^a-&0;KJ2y-*+e7S3J{LEyM34>G z;;I{oT+JNqHgU^Zvh!7z^X|uKExbFxXhu&y=G4WOt2 z1o17^8vh7I1Ks#R;p*hO2%WV74JN@hfjAwyRwOXbbo3*CRQeVhnN1k^N2N2Kjsh^T dBLdy7%#T}Jskiwn4uu#PSWA?Yw3r@D{1@QG=?MS; diff --git a/doc/src/Eqs/pair_spin_exchange_interaction.tex b/doc/src/Eqs/pair_spin_exchange_interaction.tex index f20b3e5740..8bb58e0885 100644 --- a/doc/src/Eqs/pair_spin_exchange_interaction.tex +++ b/doc/src/Eqs/pair_spin_exchange_interaction.tex @@ -1,11 +1,15 @@ \documentclass[preview]{standalone} \usepackage{varwidth} \usepackage[utf8x]{inputenc} -\usepackage{amsmath,amssymb,amsthm,bm} +\usepackage{amsmath, amssymb, graphics, setspace} + \begin{document} \begin{varwidth}{50in} \begin{equation} - \bm{H}_{ex} ~=~ -\sum_{i,j,i\neq j}^{N} {J} \left(r_{ij} \right)\, \vec{s}_{i}\cdot \vec{s}_{j} \nonumber + H_{ex} = + -\sum_{i,j}^N J_{ij} (r_{ij}) \,\vec{s}_i \cdot \vec{s}_j + %&{\rm ~if~}& \vec{m}_i^I \times \vec{m}_i^F + , \nonumber \end{equation} \end{varwidth} \end{document} diff --git a/doc/src/compute_spin.txt b/doc/src/compute_spin.txt index 0824a70dd0..dddbc856c4 100644 --- a/doc/src/compute_spin.txt +++ b/doc/src/compute_spin.txt @@ -24,17 +24,15 @@ compute out_mag all spin :pre Define a computation that calculates magnetic quantities for a system of atoms having spins. -This compute calculates 6 magnetic quantities. - -The three first quantities are the x,y and z coordinates of the total -magnetization. - -The fourth quantity is the norm of the total magnetization. - -The fifth quantity is the magnetic energy. +This compute calculates the following 6 magnetic quantities: +the three first quantities are the x,y and z coordinates of the total +magnetization, :ulb,l +the fourth quantity is the norm of the total magnetization, :l +The fifth quantity is the magnetic energy (in eV), :l The sixth one is referred to as the spin temperature, according -to the work of "(Nurdin)"_#Nurdin1. +to the work of "(Nurdin)"_#Nurdin1. :l +:ule The simplest way to output the results of the compute spin calculation is to define some of the quantities as variables, and to use the thermo and diff --git a/doc/src/pair_spin_exchange.txt b/doc/src/pair_spin_exchange.txt index 76a6d508d2..7bc6b5fef7 100644 --- a/doc/src/pair_spin_exchange.txt +++ b/doc/src/pair_spin_exchange.txt @@ -30,14 +30,15 @@ pairs of magnetic spins: :c,image(Eqs/pair_spin_exchange_interaction.jpg) where si and sj are two neighboring magnetic spins of two particles, -rij = ri - rj is the inter-atomic distance between the two particles, +rij = |ri - rj| is the inter-atomic distance between the two particles, and J(rij) is a function defining the intensity and the sign of the exchange interaction for different neighboring shells. This function is defined as: :c,image(Eqs/pair_spin_exchange_function.jpg) where a, b and d are the three constant coefficients defined in the associated -"pair_coeff" command (see below for more explanations). +"pair_coeff" command, and Rc is the radius cutoff associated to +the pair interaction (see below for more explanations). The coefficients a, b, and d need to be fitted so that the function above matches with the value of the exchange interaction for the N neighbor shells taken into account. diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 6f1e72ef7e..7d7fb56e1c 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -129,7 +129,8 @@ void ComputeSpin::compute_vector() magtot[2] *= scale; magtot[3] = sqrt((magtot[0]*magtot[0])+(magtot[1]*magtot[1])+(magtot[2]*magtot[2])); spintemperature = hbar*tempnumtot; - spintemperature /= (kb*tempdenomtot); + // spintemperature /= (kb*tempdenomtot); + spintemperature /= (2.0*kb*tempdenomtot); vector[0] = magtot[0]; vector[1] = magtot[1]; From 10f98e3f109b04e457cad9fe0f96431ccd67f6d5 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:42:02 -0500 Subject: [PATCH 428/557] Update docs: angle_none --- doc/src/angle_none.rst | 24 ++++++++++-------------- doc/txt/angle_none.txt | 34 ---------------------------------- 2 files changed, 10 insertions(+), 48 deletions(-) delete mode 100644 doc/txt/angle_none.txt diff --git a/doc/src/angle_none.rst b/doc/src/angle_none.rst index a558096211..e848391932 100644 --- a/doc/src/angle_none.rst +++ b/doc/src/angle_none.rst @@ -1,13 +1,13 @@ -.. index:: angle\_style none +.. index:: angle_style none -angle\_style none command -========================= +angle_style none command +======================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style none @@ -15,7 +15,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style none @@ -24,23 +24,19 @@ Description Using an angle style of none means angle forces and energies are not computed, even if triplets of angle atoms were listed in the data file -read by the :doc:`read\_data ` command. +read by the :doc:`read_data ` command. -See the :doc:`angle\_style zero ` command for a way to +See the :doc:`angle_style zero ` command for a way to calculate angle statistics, but compute no angle interactions. Restrictions """""""""""" - none + +none Related commands """""""""""""""" -:doc:`angle\_style zero ` +:doc:`angle_style zero ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_none.txt b/doc/txt/angle_none.txt deleted file mode 100644 index 1eca5cbbec..0000000000 --- a/doc/txt/angle_none.txt +++ /dev/null @@ -1,34 +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 - -angle_style none command :h3 - -[Syntax:] - -angle_style none :pre - -[Examples:] - -angle_style none :pre - -[Description:] - -Using an angle style of none means angle forces and energies are not -computed, even if triplets of angle atoms were listed in the data file -read by the "read_data"_read_data.html command. - -See the "angle_style zero"_angle_zero.html command for a way to -calculate angle statistics, but compute no angle interactions. - -[Restrictions:] none - -[Related commands:] - -"angle_style zero"_angle_zero.html - -[Default:] none From 71a4755a8e87c25f76700aab1331044410407c8f Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 11:48:00 -0500 Subject: [PATCH 429/557] Update docs: angle_table --- doc/src/angle_table.rst | 29 +++---- doc/txt/angle_table.txt | 166 ---------------------------------------- 2 files changed, 12 insertions(+), 183 deletions(-) delete mode 100644 doc/txt/angle_table.txt diff --git a/doc/src/angle_table.rst b/doc/src/angle_table.rst index 8d50ff7fe1..f63cf167d9 100644 --- a/doc/src/angle_table.rst +++ b/doc/src/angle_table.rst @@ -1,16 +1,16 @@ -.. index:: angle\_style table +.. index:: angle_style table -angle\_style table command -========================== +angle_style table command +========================= -angle\_style table/omp command -============================== +angle_style table/omp command +============================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style table style N @@ -21,7 +21,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS angle_style table linear 1000 angle_coeff 3 file.table ENTRY1 @@ -31,7 +31,7 @@ Description Style *table* creates interpolation tables of length *N* from angle potential and derivative values listed in a file(s) as a function of -angle The files are read by the :doc:`angle\_coeff ` +angle The files are read by the :doc:`angle_coeff ` command. The interpolation tables are created by fitting cubic splines to the @@ -50,7 +50,7 @@ find the appropriate set of coefficients which are used to evaluate a cubic polynomial which computes the energy or derivative. The following coefficients must be defined for each angle type via the -:doc:`angle\_coeff ` command as in the example above. +:doc:`angle_coeff ` command as in the example above. * filename * keyword @@ -85,13 +85,13 @@ A section begins with a non-blank line whose 1st character is not a between sections. The first line begins with a keyword which identifies the section. The line can contain additional text, but the initial text must match the argument specified in the -:doc:`angle\_coeff ` command. The next line lists (in any +:doc:`angle_coeff ` command. The next line lists (in any order) one or more parameters for the table. Each parameter is a keyword followed by one or more numeric values. The parameter "N" is required and its value is the number of table entries that follow. Note that this may be different than the *N* -specified in the :doc:`angle\_style table ` command. Let +specified in the :doc:`angle_style table ` command. Let Ntable = *N* in the angle\_style command, and Nfile = "N" in the tabulated file. What LAMMPS does is a preliminary interpolation by creating splines using the Nfile tabulated values as nodal points. It @@ -176,11 +176,6 @@ for more info. Related commands """""""""""""""" -:doc:`angle\_coeff ` +:doc:`angle_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/angle_table.txt b/doc/txt/angle_table.txt deleted file mode 100644 index 61c987f587..0000000000 --- a/doc/txt/angle_table.txt +++ /dev/null @@ -1,166 +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 - -angle_style table command :h3 -angle_style table/omp command :h3 - -[Syntax:] - -angle_style table style N :pre - -style = {linear} or {spline} = method of interpolation -N = use N values in table :ul - -[Examples:] - -angle_style table linear 1000 -angle_coeff 3 file.table ENTRY1 :pre - -[Description:] - -Style {table} creates interpolation tables of length {N} from angle -potential and derivative values listed in a file(s) as a function of -angle The files are read by the "angle_coeff"_angle_coeff.html -command. - -The interpolation tables are created by fitting cubic splines to the -file values and interpolating energy and derivative values at each of -{N} angles. During a simulation, these tables are used to interpolate -energy and force values on individual atoms as needed. The -interpolation is done in one of 2 styles: {linear} or {spline}. - -For the {linear} style, the angle is used to find 2 surrounding table -values from which an energy or its derivative is computed by linear -interpolation. - -For the {spline} style, a cubic spline coefficients are computed and -stored at each of the {N} values in the table. The angle is used to -find the appropriate set of coefficients which are used to evaluate a -cubic polynomial which computes the energy or derivative. - -The following coefficients must be defined for each angle type via the -"angle_coeff"_angle_coeff.html command as in the example above. - -filename -keyword :ul - -The filename specifies a file containing tabulated energy and -derivative values. The keyword specifies a section of the file. The -format of this file is described below. - -:line - -The format of a tabulated file is as follows (without the -parenthesized comments): - -# Angle potential for harmonic (one or more comment or blank lines) :pre - -HAM (keyword is the first text on line) -N 181 FP 0 0 EQ 90.0 (N, FP, EQ parameters) - (blank line) -N 181 FP 0 0 (N, FP parameters) -1 0.0 200.5 2.5 (index, angle, energy, derivative) -2 1.0 198.0 2.5 -... -181 180.0 0.0 0.0 :pre - -A section begins with a non-blank line whose 1st character is not a -"#"; blank lines or lines starting with "#" can be used as comments -between sections. The first line begins with a keyword which -identifies the section. The line can contain additional text, but the -initial text must match the argument specified in the -"angle_coeff"_angle_coeff.html command. The next line lists (in any -order) one or more parameters for the table. Each parameter is a -keyword followed by one or more numeric values. - -The parameter "N" is required and its value is the number of table -entries that follow. Note that this may be different than the {N} -specified in the "angle_style table"_angle_style.html command. Let -Ntable = {N} in the angle_style command, and Nfile = "N" in the -tabulated file. What LAMMPS does is a preliminary interpolation by -creating splines using the Nfile tabulated values as nodal points. It -uses these to interpolate as needed to generate energy and derivative -values at Ntable different points. The resulting tables of length -Ntable are then used as described above, when computing energy and -force for individual angles and their atoms. This means that if you -want the interpolation tables of length Ntable to match exactly what -is in the tabulated file (with effectively no preliminary -interpolation), you should set Ntable = Nfile. - -The "FP" parameter is optional. If used, it is followed by two values -fplo and fphi, which are the 2nd derivatives at the innermost and -outermost angle settings. These values are needed by the spline -construction routines. If not specified by the "FP" parameter, they -are estimated (less accurately) by the first two and last two -derivative values in the table. - -The "EQ" parameter is also optional. If used, it is followed by a the -equilibrium angle value, which is used, for example, by the "fix -shake"_fix_shake.html command. If not used, the equilibrium angle is -set to 180.0. - -Following a blank line, the next N lines list the tabulated values. -On each line, the 1st value is the index from 1 to N, the 2nd value is -the angle value (in degrees), the 3rd value is the energy (in energy -units), and the 4th is -dE/d(theta) (also in energy units). The 3rd -term is the energy of the 3-atom configuration for the specified -angle. The last term is the derivative of the energy with respect to -the angle (in degrees, not radians). Thus the units of the last term -are still energy, not force. The angle values must increase from one -line to the next. The angle values must also begin with 0.0 and end -with 180.0, i.e. span the full range of possible angles. - -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. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -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 -MOLECULE package. See the "Build package"_Build_package.html doc page -for more info. - -[Related commands:] - -"angle_coeff"_angle_coeff.html - -[Default:] none From 7e58920fe37c1224d9912a56687c3437b172009f Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 12:35:50 -0500 Subject: [PATCH 430/557] move developer's guide tex sources back to src/Developer --- doc/{txt => src}/Developer/.gitignore | 0 doc/{txt => src}/Developer/classes.fig | 0 doc/{txt => src}/Developer/classes.pdf | Bin doc/{txt => src}/Developer/developer.tex | 0 4 files changed, 0 insertions(+), 0 deletions(-) rename doc/{txt => src}/Developer/.gitignore (100%) rename doc/{txt => src}/Developer/classes.fig (100%) rename doc/{txt => src}/Developer/classes.pdf (100%) rename doc/{txt => src}/Developer/developer.tex (100%) diff --git a/doc/txt/Developer/.gitignore b/doc/src/Developer/.gitignore similarity index 100% rename from doc/txt/Developer/.gitignore rename to doc/src/Developer/.gitignore diff --git a/doc/txt/Developer/classes.fig b/doc/src/Developer/classes.fig similarity index 100% rename from doc/txt/Developer/classes.fig rename to doc/src/Developer/classes.fig diff --git a/doc/txt/Developer/classes.pdf b/doc/src/Developer/classes.pdf similarity index 100% rename from doc/txt/Developer/classes.pdf rename to doc/src/Developer/classes.pdf diff --git a/doc/txt/Developer/developer.tex b/doc/src/Developer/developer.tex similarity index 100% rename from doc/txt/Developer/developer.tex rename to doc/src/Developer/developer.tex From 334a74830d85c7f8b1f6b52fa4733d0e6d7055c6 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Fri, 15 Nov 2019 12:48:43 -0500 Subject: [PATCH 431/557] Fix equations --- doc/src/angle_class2.rst | 8 ++++---- doc/src/angle_dipole.rst | 4 ++-- 2 files changed, 6 insertions(+), 6 deletions(-) diff --git a/doc/src/angle_class2.rst b/doc/src/angle_class2.rst index b045cc6917..9d1ff8e8e7 100644 --- a/doc/src/angle_class2.rst +++ b/doc/src/angle_class2.rst @@ -38,10 +38,10 @@ The *class2* angle style uses the potential .. math:: - E & = & E_a + E_{bb} + E_{ba} \\ - E_a & = & K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4 (\theta - \theta_0)^4 \\ - E_{bb} & = & M (r_{ij} - r_1) (r_{jk} - r_2) \\ - E_{ba} & = & N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2 (r_{jk} - r_2) (\theta - \theta_0) + E & = E_a + E_{bb} + E_{ba} \\ + E_a & = K_2 (\theta - \theta_0)^2 + K_3 (\theta - \theta_0)^3 + K_4(\theta - \theta_0)^4 \\ + E_{bb} & = M (r_{ij} - r_1) (r_{jk} - r_2) \\ + E_{ba} & = N_1 (r_{ij} - r_1) (\theta - \theta_0) + N_2(r_{jk} - r_2)(\theta - \theta_0) where :math:`E_a` is the angle term, :math:`E_{bb}` is a bond-bond term, and :math:`E_{ba}` is a diff --git a/doc/src/angle_dipole.rst b/doc/src/angle_dipole.rst index 0ad7da5069..351572cc22 100644 --- a/doc/src/angle_dipole.rst +++ b/doc/src/angle_dipole.rst @@ -71,8 +71,8 @@ couple generating a torque equivalent to the opposite of :math:`\vec{T_j}`: .. math:: - -\vec{T_j} & = & \vec{r_{ij}} \times \vec{F_i}\\ - \vec{F_j} & = & -\vec{F_i} \\ + -\vec{T_j} & = \vec{r_{ij}} \times \vec{F_i} \\ + \vec{F_j} & = -\vec{F_i} where :math:`\vec{F_i}` and :math:`\vec{F_j}` are applied on atoms :math:`i` From f96520ffc65c8f624dc37424ffcd18978dc7e7db Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 17:49:17 +0000 Subject: [PATCH 432/557] Added unique base pairing --- examples/USER/cgdna/README | 17 + .../oxDNA2/unique_bp/data.duplex4.4type | 130 +++ .../oxDNA2/unique_bp/data.duplex4.8type | 130 +++ .../oxDNA2/unique_bp/generate_unique.py | 828 ++++++++++++++++++ .../oxDNA2/unique_bp/in.duplex4.4type | 94 ++ .../oxDNA2/unique_bp/in.duplex4.8type | 94 ++ .../unique_bp/log.07Aug19.duplex4.4type.g++1 | 232 +++++ .../unique_bp/log.07Aug19.duplex4.4type.g++4 | 232 +++++ .../unique_bp/log.07Aug19.duplex4.8type.g++1 | 274 ++++++ .../unique_bp/log.07Aug19.duplex4.8type.g++4 | 274 ++++++ 10 files changed, 2305 insertions(+) create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.4type create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.8type create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/generate_unique.py create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.4type create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.8type create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++1 create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++4 create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++1 create mode 100644 examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++4 diff --git a/examples/USER/cgdna/README b/examples/USER/cgdna/README index a03490b630..7cbf76fd5a 100644 --- a/examples/USER/cgdna/README +++ b/examples/USER/cgdna/README @@ -55,6 +55,23 @@ are sequence-dependent (cf. keyword 'seqdep' in according pair styles). /******************************************************************************/ +/examples/oxDNA2/unique_bp: + +This example uses atom types 1-8 to model a 13 base pair duplex. +The nucleotide types are assigned as follows: +A = 1,5; C = 2,6; G = 3,7; T = 4,8 +When a large number of atom types is used, this feature allows +quasi-unique base pairing between two individual nucleotides. + +The topology is +A C G T A C G T A C G T A +1 - 2 - 3 - 4 - 5 - 6 - 7 - 8 - 1 - 2 - 7 - 8 - 1 +| | | | | | | | | | | | | +4 - 3 - 2 - 1 - 8 - 7 - 6 - 5 - 4 - 3 - 6 - 5 - 4 +T G C A T G C A T G C A T + +/******************************************************************************/ + /examples/oxRNA2/duplex4 This is the duplex2 run with the oxRNA2 force field instead of the oxDNA or diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.4type b/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.4type new file mode 100644 index 0000000000..a8412eef07 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.4type @@ -0,0 +1,130 @@ +# LAMMPS data file +26 atoms +26 ellipsoids +24 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 + +# 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.957432645895970e-01 -3.379920348381733e-01 3.897628551303122e-01 1 1 1 +3 3 -2.192046146198370e-01 -5.585242491865227e-01 7.795257102606244e-01 1 1 1 +4 4 1.335125603737887e-01 -5.849567473090943e-01 1.169288565390937e+00 1 1 1 +5 1 4.398311230978960e-01 -4.081036426625517e-01 1.559051420521249e+00 1 1 1 +6 2 5.932984957350773e-01 -8.942535970570469e-02 1.948814275651561e+00 1 1 1 +7 3 5.405813207414517e-01 2.603302434705350e-01 2.338577130781873e+00 1 1 1 +8 4 3.000000000000002e-01 5.196152422706634e-01 2.728339985912185e+00 1 1 1 +9 1 -4.483805615185452e-02 5.983222783087083e-01 3.118102841042497e+00 1 1 1 +10 2 -3.740938811152403e-01 4.690988894808181e-01 3.507865696172809e+00 1 1 1 +11 3 -5.733436834716847e-01 1.768531046465427e-01 3.897628551303121e+00 1 1 1 +12 4 -5.733436834716849e-01 -1.768531046465427e-01 4.287391406433434e+00 1 1 1 +13 1 -3.740938811152403e-01 -4.690988894808182e-01 4.677154261563746e+00 1 1 1 +14 4 3.740938811152403e-01 4.690988894808182e-01 4.677154261563746e+00 2 1 1 +15 1 5.733436834716849e-01 1.768531046465427e-01 4.287391406433434e+00 2 1 1 +16 2 5.733436834716849e-01 -1.768531046465426e-01 3.897628551303122e+00 2 1 1 +17 3 3.740938811152403e-01 -4.690988894808181e-01 3.507865696172810e+00 2 1 1 +18 4 4.483805615185462e-02 -5.983222783087085e-01 3.118102841042498e+00 2 1 1 +19 1 -3.000000000000003e-01 -5.196152422706636e-01 2.728339985912186e+00 2 1 1 +20 2 -5.405813207414519e-01 -2.603302434705351e-01 2.338577130781874e+00 2 1 1 +21 3 -5.932984957350776e-01 8.942535970570474e-02 1.948814275651561e+00 2 1 1 +22 4 -4.398311230978962e-01 4.081036426625520e-01 1.559051420521249e+00 2 1 1 +23 1 -1.335125603737888e-01 5.849567473090947e-01 1.169288565390937e+00 2 1 1 +24 2 2.192046146198373e-01 5.585242491865231e-01 7.795257102606246e-01 2 1 1 +25 3 4.957432645895974e-01 3.379920348381736e-01 3.897628551303123e-01 2 1 1 +26 4 6.000000000000006e-01 0.000000000000000e+00 1.110223024625157e-16 2 1 1 + +# Atom-ID, translational, rotational velocity +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 +11 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +12 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +13 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +14 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +15 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +16 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +17 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +18 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +19 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +20 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +21 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +22 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +23 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +24 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +25 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +26 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 + +# Atom-ID, shape, quaternion +Ellipsoids + +1 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 1.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +2 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.555728057861408e-01 0.000000000000000e+00 0.000000000000000e+00 2.947551744109042e-01 +3 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 8.262387743159949e-01 0.000000000000000e+00 0.000000000000000e+00 5.633200580636221e-01 +4 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 6.234898018587335e-01 0.000000000000000e+00 0.000000000000000e+00 7.818314824680299e-01 +5 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 3.653410243663950e-01 0.000000000000000e+00 0.000000000000000e+00 9.308737486442042e-01 +6 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 7.473009358642424e-02 0.000000000000000e+00 0.000000000000000e+00 9.972037971811802e-01 +7 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -2.225209339563144e-01 0.000000000000000e+00 0.000000000000000e+00 9.749279121818237e-01 +8 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -5.000000000000001e-01 0.000000000000000e+00 0.000000000000000e+00 8.660254037844387e-01 +9 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 7.330518718298263e-01 -0.000000000000000e+00 0.000000000000000e+00 -6.801727377709196e-01 +10 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.009688679024190e-01 -0.000000000000000e+00 0.000000000000000e+00 -4.338837391175581e-01 +11 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.888308262251286e-01 -0.000000000000000e+00 0.000000000000000e+00 -1.490422661761745e-01 +12 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.888308262251286e-01 0.000000000000000e+00 0.000000000000000e+00 1.490422661761745e-01 +13 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.009688679024190e-01 0.000000000000000e+00 0.000000000000000e+00 4.338837391175582e-01 +14 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 -4.338837391175582e-01 9.009688679024190e-01 0.000000000000000e+00 +15 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 -1.490422661761746e-01 9.888308262251286e-01 0.000000000000000e+00 +16 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 1.490422661761745e-01 9.888308262251286e-01 -0.000000000000000e+00 +17 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 4.338837391175581e-01 9.009688679024190e-01 -0.000000000000000e+00 +18 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 6.801727377709192e-01 7.330518718298267e-01 0.000000000000000e+00 +19 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 8.660254037844386e-01 5.000000000000001e-01 0.000000000000000e+00 +20 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.749279121818235e-01 2.225209339563145e-01 0.000000000000000e+00 +21 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.972037971811801e-01 -7.473009358642428e-02 0.000000000000000e+00 +22 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.308737486442041e-01 -3.653410243663952e-01 0.000000000000000e+00 +23 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 7.818314824680296e-01 -6.234898018587339e-01 0.000000000000000e+00 +24 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 5.633200580636215e-01 -8.262387743159952e-01 0.000000000000000e+00 +25 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 -2.947551744109044e-01 9.555728057861407e-01 0.000000000000000e+00 +26 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 0.000000000000000e+00 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 5 6 +6 1 6 7 +7 1 7 8 +8 1 8 9 +9 1 9 10 +10 1 10 11 +11 1 11 12 +12 1 12 13 +13 1 14 15 +14 1 15 16 +15 1 16 17 +16 1 17 18 +17 1 18 19 +18 1 19 20 +19 1 20 21 +20 1 21 22 +21 1 22 23 +22 1 23 24 +23 1 24 25 +24 1 25 26 diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.8type b/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.8type new file mode 100644 index 0000000000..b4d622ac46 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/data.duplex4.8type @@ -0,0 +1,130 @@ +# LAMMPS data file +26 atoms +26 ellipsoids +24 bonds + +8 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 + +# 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.957432645895970e-01 -3.379920348381733e-01 3.897628551303122e-01 1 1 1 +3 3 -2.192046146198370e-01 -5.585242491865227e-01 7.795257102606244e-01 1 1 1 +4 4 1.335125603737887e-01 -5.849567473090943e-01 1.169288565390937e+00 1 1 1 +5 5 4.398311230978960e-01 -4.081036426625517e-01 1.559051420521249e+00 1 1 1 +6 6 5.932984957350773e-01 -8.942535970570469e-02 1.948814275651561e+00 1 1 1 +7 7 5.405813207414517e-01 2.603302434705350e-01 2.338577130781873e+00 1 1 1 +8 8 3.000000000000002e-01 5.196152422706634e-01 2.728339985912185e+00 1 1 1 +9 1 -4.483805615185452e-02 5.983222783087083e-01 3.118102841042497e+00 1 1 1 +10 2 -3.740938811152403e-01 4.690988894808181e-01 3.507865696172809e+00 1 1 1 +11 7 -5.733436834716847e-01 1.768531046465427e-01 3.897628551303121e+00 1 1 1 +12 8 -5.733436834716849e-01 -1.768531046465427e-01 4.287391406433434e+00 1 1 1 +13 1 -3.740938811152403e-01 -4.690988894808182e-01 4.677154261563746e+00 1 1 1 +14 4 3.740938811152403e-01 4.690988894808182e-01 4.677154261563746e+00 2 1 1 +15 5 5.733436834716849e-01 1.768531046465427e-01 4.287391406433434e+00 2 1 1 +16 6 5.733436834716849e-01 -1.768531046465426e-01 3.897628551303122e+00 2 1 1 +17 3 3.740938811152403e-01 -4.690988894808181e-01 3.507865696172810e+00 2 1 1 +18 4 4.483805615185462e-02 -5.983222783087085e-01 3.118102841042498e+00 2 1 1 +19 5 -3.000000000000003e-01 -5.196152422706636e-01 2.728339985912186e+00 2 1 1 +20 6 -5.405813207414519e-01 -2.603302434705351e-01 2.338577130781874e+00 2 1 1 +21 7 -5.932984957350776e-01 8.942535970570474e-02 1.948814275651561e+00 2 1 1 +22 8 -4.398311230978962e-01 4.081036426625520e-01 1.559051420521249e+00 2 1 1 +23 1 -1.335125603737888e-01 5.849567473090947e-01 1.169288565390937e+00 2 1 1 +24 2 2.192046146198373e-01 5.585242491865231e-01 7.795257102606246e-01 2 1 1 +25 3 4.957432645895974e-01 3.379920348381736e-01 3.897628551303123e-01 2 1 1 +26 4 6.000000000000006e-01 0.000000000000000e+00 1.110223024625157e-16 2 1 1 + +# Atom-ID, translational, rotational velocity +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 +11 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +12 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +13 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +14 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +15 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +16 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +17 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +18 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +19 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +20 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +21 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +22 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +23 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +24 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +25 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +26 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 + +# Atom-ID, shape, quaternion +Ellipsoids + +1 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 1.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 0.000000000000000e+00 +2 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.555728057861408e-01 0.000000000000000e+00 0.000000000000000e+00 2.947551744109042e-01 +3 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 8.262387743159949e-01 0.000000000000000e+00 0.000000000000000e+00 5.633200580636221e-01 +4 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 6.234898018587335e-01 0.000000000000000e+00 0.000000000000000e+00 7.818314824680299e-01 +5 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 3.653410243663950e-01 0.000000000000000e+00 0.000000000000000e+00 9.308737486442042e-01 +6 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 7.473009358642424e-02 0.000000000000000e+00 0.000000000000000e+00 9.972037971811802e-01 +7 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -2.225209339563144e-01 0.000000000000000e+00 0.000000000000000e+00 9.749279121818237e-01 +8 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -5.000000000000001e-01 0.000000000000000e+00 0.000000000000000e+00 8.660254037844387e-01 +9 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 7.330518718298263e-01 -0.000000000000000e+00 0.000000000000000e+00 -6.801727377709196e-01 +10 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.009688679024190e-01 -0.000000000000000e+00 0.000000000000000e+00 -4.338837391175581e-01 +11 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.888308262251286e-01 -0.000000000000000e+00 0.000000000000000e+00 -1.490422661761745e-01 +12 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.888308262251286e-01 0.000000000000000e+00 0.000000000000000e+00 1.490422661761745e-01 +13 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 9.009688679024190e-01 0.000000000000000e+00 0.000000000000000e+00 4.338837391175582e-01 +14 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 -4.338837391175582e-01 9.009688679024190e-01 0.000000000000000e+00 +15 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 -1.490422661761746e-01 9.888308262251286e-01 0.000000000000000e+00 +16 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 1.490422661761745e-01 9.888308262251286e-01 -0.000000000000000e+00 +17 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 4.338837391175581e-01 9.009688679024190e-01 -0.000000000000000e+00 +18 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 6.801727377709192e-01 7.330518718298267e-01 0.000000000000000e+00 +19 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 8.660254037844386e-01 5.000000000000001e-01 0.000000000000000e+00 +20 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.749279121818235e-01 2.225209339563145e-01 0.000000000000000e+00 +21 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.972037971811801e-01 -7.473009358642428e-02 0.000000000000000e+00 +22 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 9.308737486442041e-01 -3.653410243663952e-01 0.000000000000000e+00 +23 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 7.818314824680296e-01 -6.234898018587339e-01 0.000000000000000e+00 +24 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 0.000000000000000e+00 5.633200580636215e-01 -8.262387743159952e-01 0.000000000000000e+00 +25 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 -2.947551744109044e-01 9.555728057861407e-01 0.000000000000000e+00 +26 1.173984503142341e+00 1.173984503142341e+00 1.173984503142341e+00 -0.000000000000000e+00 0.000000000000000e+00 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 5 6 +6 1 6 7 +7 1 7 8 +8 1 8 9 +9 1 9 10 +10 1 10 11 +11 1 11 12 +12 1 12 13 +13 1 14 15 +14 1 15 16 +15 1 16 17 +16 1 17 18 +17 1 18 19 +18 1 19 20 +19 1 20 21 +20 1 21 22 +21 1 22 23 +22 1 23 24 +23 1 24 25 +24 1 25 26 diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/generate_unique.py b/examples/USER/cgdna/examples/oxDNA2/unique_bp/generate_unique.py new file mode 100644 index 0000000000..e5141bc47a --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/generate_unique.py @@ -0,0 +1,828 @@ +#!/usr/bin/env python +""" +/* ---------------------------------------------------------------------- + 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) +------------------------------------------------------------------------- */ +""" +""" +Creates unique base-pairings to avoid asymmetrical H-bonds. + +Modified to create the bead wall setup. +N_BEADS is the number of beads along one direction, the final system will have N_BEADS^2 beads in the wall. N_BEADS should be set to be odd number. +""" + + +#Define number of base-pairs per turn for B-form DNA +N = 10.5 +#Define distance between the big bead and the centre of mass of the last base-pair +BEAD_OFFSET = 2.0 +WALL_PARTICLE_SIZE = 2.0 +N_BEADS = 11 + +#Number of unique base type groups (1-4) ACGT counts as one group +N_BASE_TYPES = 20 + + +""" +Import basic modules +""" +import sys, os, timeit + +from timeit import default_timer as timer +start_time = timer() +""" +Try to import numpy; if failed, import a local version mynumpy +which needs to be provided +""" +try: + import numpy as np +except: + print("numpy not found. Exiting.", file=sys.stderr) + sys.exit(1) + +""" +Check that the required arguments (box offset and size in simulation units +and the sequence file were provided +""" +try: + box_offset = float(sys.argv[1]) + box_length = float(sys.argv[2]) + infile = sys.argv[3] + if len(sys.argv) == 4: + topo = 'strand' + lk = 0 + elif len(sys.argv) == 5: + topo = 'strand' + lk = int(sys.argv[4]) + +except: + print("Usage: %s <%s> <%s> <%s> <%s> " % (sys.argv[0], \ + "box offset", "box length", "file with sequences", "[Lk]"), file=sys.stderr) + sys.exit(1) +box = np.array ([box_length, box_length, box_length]) + +""" +Try to open the file and fail gracefully if file cannot be opened +""" +try: + inp = open (infile, 'r') + inp.close() +except: + print("Could not open file '%s' for reading. \ + Aborting." % infile, file=sys.stderr) + sys.exit(2) + +# return parts of a string +def partition(s, d): + if d in s: + sp = s.split(d, 1) + return sp[0], d, sp[1] + else: + return s, "", "" + +""" +Define the model constants +""" +# set model constants +PI = np.pi +POS_BASE = 0.4 +POS_BACK = -0.4 +EXCL_RC1 = 0.711879214356 +EXCL_RC2 = 0.335388426126 +EXCL_RC3 = 0.52329943261 + +""" +Define auxillary variables for the construction of a helix +""" +# center of the double strand +COM_CENTRE_DS = POS_BASE + 0.2 + +# ideal rise between two consecutive nucleotides on the +# same strand which are to be base paired in a duplex +BASE_BASE = 0.3897628551303122 + +# cutoff distance for overlap check +RC2 = 16 + +# squares of the excluded volume distances for overlap check +RC2_BACK = EXCL_RC1**2 +RC2_BASE = EXCL_RC2**2 +RC2_BACK_BASE = EXCL_RC3**2 + +# enumeration to translate from letters to numbers and vice versa +number_to_base = {1 : 'A', 2 : 'C', 3 : 'G', 4 : 'T'} +base_to_number = {'A' : 1, 'a' : 1, 'C' : 2, 'c' : 2, + 'G' : 3, 'g' : 3, 'T' : 4, 't' : 4} + +# auxillary arrays +positions = [] +a1s = [] +a3s = [] +quaternions = [] + +newpositions = [] +newa1s = [] +newa3s = [] + +basetype = [] +strandnum = [] + +bonds = [] + +""" +Convert local body frame to quaternion DOF +""" +def exyz_to_quat (mya1, mya3): + + mya2 = np.cross(mya3, mya1) + myquat = [1,0,0,0] + + q0sq = 0.25 * (mya1[0] + mya2[1] + mya3[2] + 1.0) + q1sq = q0sq - 0.5 * (mya2[1] + mya3[2]) + q2sq = q0sq - 0.5 * (mya1[0] + mya3[2]) + q3sq = q0sq - 0.5 * (mya1[0] + mya2[1]) + + # some component must be greater than 1/4 since they sum to 1 + # compute other components from it + + if q0sq >= 0.25: + myquat[0] = np.sqrt(q0sq) + myquat[1] = (mya2[2] - mya3[1]) / (4.0*myquat[0]) + myquat[2] = (mya3[0] - mya1[2]) / (4.0*myquat[0]) + myquat[3] = (mya1[1] - mya2[0]) / (4.0*myquat[0]) + elif q1sq >= 0.25: + myquat[1] = np.sqrt(q1sq) + myquat[0] = (mya2[2] - mya3[1]) / (4.0*myquat[1]) + myquat[2] = (mya2[0] + mya1[1]) / (4.0*myquat[1]) + myquat[3] = (mya1[2] + mya3[0]) / (4.0*myquat[1]) + elif q2sq >= 0.25: + myquat[2] = np.sqrt(q2sq) + myquat[0] = (mya3[0] - mya1[2]) / (4.0*myquat[2]) + myquat[1] = (mya2[0] + mya1[1]) / (4.0*myquat[2]) + myquat[3] = (mya3[1] + mya2[2]) / (4.0*myquat[2]) + elif q3sq >= 0.25: + myquat[3] = np.sqrt(q3sq) + myquat[0] = (mya1[1] - mya2[0]) / (4.0*myquat[3]) + myquat[1] = (mya3[0] + mya1[2]) / (4.0*myquat[3]) + myquat[2] = (mya3[1] + mya2[2]) / (4.0*myquat[3]) + + norm = 1.0/np.sqrt(myquat[0]*myquat[0] + myquat[1]*myquat[1] + \ + myquat[2]*myquat[2] + myquat[3]*myquat[3]) + myquat[0] *= norm + myquat[1] *= norm + myquat[2] *= norm + myquat[3] *= norm + + return np.array([myquat[0],myquat[1],myquat[2],myquat[3]]) + +""" +Adds a strand to the system by appending it to the array of previous strands +""" +def add_strands (mynewpositions, mynewa1s, mynewa3s): + overlap = False + + # This is a simple check for each of the particles where for previously + # placed particles i we check whether it overlaps with any of the + # newly created particles j + + print("## Checking for overlaps", file=sys.stdout) + + for i in range(len(positions)): + + p = positions[i] + pa1 = a1s[i] + + for j in range (len(mynewpositions)): + + q = mynewpositions[j] + qa1 = mynewa1s[j] + + # skip particles that are anyway too far away + dr = p - q + dr -= box * np.rint (dr / box) + if np.dot(dr, dr) > RC2: + continue + + # base site and backbone site of the two particles + p_pos_back = p + pa1 * POS_BACK + p_pos_base = p + pa1 * POS_BASE + q_pos_back = q + qa1 * POS_BACK + q_pos_base = q + qa1 * POS_BASE + + # check for no overlap between the two backbone sites + dr = p_pos_back - q_pos_back + dr -= box * np.rint (dr / box) + if np.dot(dr, dr) < RC2_BACK: + overlap = True + + # check for no overlap between the two base sites + dr = p_pos_base - q_pos_base + dr -= box * np.rint (dr / box) + if np.dot(dr, dr) < RC2_BASE: + overlap = True + + # check for no overlap between backbone site of particle p + # with base site of particle q + dr = p_pos_back - q_pos_base + dr -= box * np.rint (dr / box) + if np.dot(dr, dr) < RC2_BACK_BASE: + overlap = True + + # check for no overlap between base site of particle p and + # backbone site of particle q + dr = p_pos_base - q_pos_back + dr -= box * np.rint (dr / box) + if np.dot(dr, dr) < RC2_BACK_BASE: + overlap = True + + # exit if there is an overlap + if overlap: + return False + + # append to the existing list if no overlap is found + if not overlap: + + for p in mynewpositions: + positions.append(p) + for p in mynewa1s: + a1s.append (p) + for p in mynewa3s: + a3s.append (p) + # calculate quaternion from local body frame and append + for ia in range(len(mynewpositions)): + mynewquaternions = exyz_to_quat(mynewa1s[ia],mynewa3s[ia]) + quaternions.append(mynewquaternions) + + return True + +""" +Calculate angle of rotation site to site +""" +def get_angle(bp): + #n, minimal number of bases per turn + n = 10.5 + found = False + while found == False: + turns = bp/n + diff = abs( turns - round(turns)) + if diff < 0.03: + found = True + turns = round(turns)+lk + angle = (360*turns)/bp + angle = round (angle,2) + #angle =round( 360/n,2) + elif n > 11.5: + angle = 35.9 + found = True + else: + n += 0.02 + return angle + + +def get_angle2(bp): + turns = bp/N + lk + angle = (360*turns)/bp + + return angle + + + +""" +Returns the rotation matrix defined by an axis and angle +""" +def get_rotation_matrix(axis, anglest, nbp=0): + # The argument anglest can be either an angle in radiants + # (accepted types are float, int or np.float64 or np.float64) + # or a tuple [angle, units] where angle is a number and + # units is a string. It tells the routine whether to use degrees, + # radiants (the default) or base pairs turns. + if not isinstance (anglest, (np.float64, np.float32, float, int)): + if len(anglest) > 1: + if anglest[1] in ["degrees", "deg", "o"]: + angle = (np.pi / 180.) * (anglest[0]) + elif anglest[1] in ["bp"]: + if nbp == 0: + angle = int(anglest[0]) * (np.pi / 180.) * (35.9) + else: + ang = get_angle2(nbp) + angle = int(anglest[0]) * (np.pi / 180.) * (ang) + else: + angle = float(anglest[0]) + else: + angle = float(anglest[0]) + else: + angle = float(anglest) # in degrees (?) + + axis = np.array(axis) + axis /= np.sqrt(np.dot(axis, axis)) + + ct = np.cos(angle) + st = np.sin(angle) + olc = 1. - ct + x, y, z = axis + + return np.array([[olc*x*x+ct, olc*x*y-st*z, olc*x*z+st*y], + [olc*x*y+st*z, olc*y*y+ct, olc*y*z-st*x], + [olc*x*z-st*y, olc*y*z+st*x, olc*z*z+ct]]) + +""" +Generates the position and orientation vectors of a +(single or double) strand from a sequence string +""" +def generate_strand(bp, sequence=None, start_pos=np.array([0, 0, 0]), \ + dir=np.array([0, 0, 1]), perp=False, double=True, rot=0.): + # generate empty arrays + mynewpositions, mynewa1s, mynewa3s = [], [], [] + + # cast the provided start_pos array into a numpy array + start_pos = np.array(start_pos, dtype=float) + + # overall direction of the helix + dir = np.array(dir, dtype=float) + #if sequence == None: + # sequence = np.random.randint(1, 5, bp) + + # the elseif here is most likely redundant + #elif len(sequence) != bp: + # n = bp - len(sequence) + # sequence += np.random.randint(1, 5, n) + # print("sequence is too short, adding %d random bases" % n, file=sys.stderr) + + # normalize direction + dir_norm = np.sqrt(np.dot(dir,dir)) + if dir_norm < 1e-10: + print("direction must be a valid vector,\ + defaulting to (0, 0, 1)", file=sys.stderr) + dir = np.array([0, 0, 1]) + else: dir /= dir_norm + + # find a vector orthogonal to dir to act as helix direction, + # if not provided switch off random orientation + if perp is None or perp is False: + v1 = np.random.random_sample(3) + # comment in to suppress randomised base vector + v1 = [1,0,0] + v1 -= dir * (np.dot(dir, v1)) + v1 /= np.sqrt(sum(v1*v1)) + else: + v1 = perp; + + # generate rotational matrix representing the overall rotation of the helix + R0 = get_rotation_matrix(dir, rot) + + # rotation matrix corresponding to one step along the helix + R = get_rotation_matrix(dir, [1, "bp"],bp) + + # set the vector a1 (backbone to base) to v1 + a1 = v1 + + # apply the global rotation to a1 + a1 = np.dot(R0, a1) + + # set the position of the fist backbone site to start_pos + rb = np.array(start_pos) + + # set a3 to the direction of the helix + a3 = dir + + for i in range(bp): + # work out the position of the centre of mass of the nucleotide + rcom = rb - COM_CENTRE_DS * a1 + + # append to newpositions + mynewpositions.append(rcom) + mynewa1s.append(a1) + mynewa3s.append(a3) + + # if we are not at the end of the helix, we work out a1 and rb for the + # next nucleotide along the helix + if i != bp - 1: + a1 = np.dot(R, a1) + rb += a3 * BASE_BASE + + # if we are working on a double strand, we do a cycle similar + # to the previous one but backwards + if double == True: + a1 = -a1 + a3 = -dir + R = R.transpose() + for i in range(bp): + rcom = rb - COM_CENTRE_DS * a1 + mynewpositions.append (rcom) + mynewa1s.append (a1) + mynewa3s.append (a3) + a1 = np.dot(R, a1) + rb += a3 * BASE_BASE + + + #Calculate the positions of the bead wall + + last_base1 = mynewpositions[int( len(mynewpositions)/2 - 1) ] + last_base2 = mynewpositions[int( len(mynewpositions)/2) ] + mid_point = (last_base1 + last_base2) / 2 + + NN = N_BEADS**2 + p1 = [mid_point[0] - (N_BEADS-1)*WALL_PARTICLE_SIZE, mid_point[1] - (N_BEADS-1)*WALL_PARTICLE_SIZE, mid_point[2] + BEAD_OFFSET ] + for i in range(N_BEADS): + for j in range(N_BEADS): + position = [ p1[0] + 2*i*WALL_PARTICLE_SIZE, p1[1] + 2*j*WALL_PARTICLE_SIZE, p1[2]] + mynewa1s.append([1,0,0]) + mynewa3s.append([1,0,0]) + mynewpositions.append(position) + + assert (len (mynewpositions) > 0) + + return [mynewpositions, mynewa1s, mynewa3s] + + + +""" +Main function for this script. +Reads a text file with the following format: +- Each line contains the sequence for a single strand (A,C,G,T) +- Lines beginning with the keyword 'DOUBLE' produce double-stranded DNA + +Ex: Two ssDNA (single stranded DNA) +ATATATA +GCGCGCG + +Ex: Two strands, one double stranded, the other single stranded. +DOUBLE AGGGCT +CCTGTA + +""" + +def read_strands(filename): + try: + infile = open (filename) + except: + print("Could not open file '%s'. Aborting." % filename, file=sys.stderr) + sys.exit(2) + + # This block works out the number of nucleotides and strands by reading + # the number of non-empty lines in the input file and the number of letters, + # taking the possible DOUBLE keyword into account. + nstrands, nnucl, nbonds = 0, 0, 0 + lines = infile.readlines() + for line in lines: + line = line.upper().strip() + if len(line) == 0: + continue + if line[:6] == 'DOUBLE': + line = line.split()[1] + length = len(line) + print("## Found duplex of %i base pairs" % length, file=sys.stdout) + nnucl += 2*length + nstrands += 2 + nbonds+= 2*length + + else: + line = line.split()[0] + length = len(line) + print("## Found single strand of %i bases" % length, file=sys.stdout) + nnucl += length + nstrands += 1 + if topo == 'ring': + nbonds =+ length + else: + nbonds += length+1 + # rewind the sequence input file + infile.seek(0) + + print("## nstrands, nnucl = ", nstrands, nnucl, file=sys.stdout) + + # generate the data file in LAMMPS format + try: + out = open ("data.oxdna", "w") + except: + print("Could not open data file for writing. Aborting.", file=sys.stderr) + sys.exit(2) + + lines = infile.readlines() + nlines = len(lines) + i = 1 + myns = 0 + noffset = 1 + + for line in lines: + line = line.upper().strip() + + # skip empty lines + if len(line) == 0: + i += 1 + continue + + # block for duplexes: last argument of the generate function + # is set to 'True' + if line[:6] == 'DOUBLE': + line = line.split()[1] + length = len(line) + seq = [(base_to_number[x]) for x in line] + seq = np.array(seq,dtype=int) + n_a, n_c, n_g, n_t = 0, 0, 0, 0 + for s in range(seq.size): + if seq[s] == 1: + n_a += 1 + elif seq[s] == 2: + n_c += 1 + elif seq[s] ==3: + n_g += 1 + elif seq[s] == 4: + n_t += 1 + smallest_n_bases = n_c + if n_a < n_c: + smallest_n_bases = n_a + if smallest_n_bases > n_t: + smallest_n_bases = n_t + if smallest_n_bases > n_g: + smallest_n_bases = n_g + + if smallest_n_bases < N_BASE_TYPES: + print('## Not enough occurances of base types in the sequence for ' + str(N_BASE_TYPES)) + print('## unique base types, switching to ' + str(smallest_n_bases) + ' unique types') + else: + smallest_n_bases = N_BASE_TYPES + + a, c, g, t = -3, -2, -1, 0 + for s in range(seq.size): + if seq[s] == 1: + if a < (smallest_n_bases*4-3): + a += 4 + else: + a = 1 + seq[s] = a + + elif seq[s] == 2: + if c < (smallest_n_bases*4-2): + c += 4 + else: + c = 2 + seq[s] = c + + elif seq[s] == 3: + if g < (smallest_n_bases*4-1): + g += 4 + else: + g = 3 + seq[s] = g + elif seq[s] == 4: + if t < (smallest_n_bases*4): + t += 4 + else: + t = 4 + seq[s] = t + + + + myns += 1 + + for b in range(length): + basetype.append(seq[b]) + strandnum.append(myns) + + for b in range(length-1): + bondpair = [noffset + b, noffset + b + 1] + bonds.append(bondpair) + + + noffset += length + + # create the sequence of the second strand as made of + # complementary bases + #seq2 = [5-s for s in seq] + seq2 = seq + for s in range(seq2.size): + if seq2[s]%4 == 1: + seq2[s] += 3 + elif seq2[s]%4 == 2: + seq2[s] += 1 + elif seq2[s]%4 == 3: + seq2[s] -= 1 + elif seq2[s]%4 == 0: + seq2[s] -= 3 + + #seq2.reverse() + + myns += 1 + + for b in range(length): + basetype.append(seq2[b]) + strandnum.append(myns) + + for b in range(length-1): + bondpair = [noffset + b, noffset + b + 1] + bonds.append(bondpair) + + + #create wall bead types + bead_type = 4*smallest_n_bases + 1 + for i in range(N_BEADS**2): + + basetype.append(bead_type) + basetype.append(bead_type) + strandnum.append(bead_type) + strandnum.append(bead_type) + #bonds.append([length, noffset + length]) + #bonds.append([length+1, noffset + length]) + + noffset += length + + print("## Created duplex of %i bases" % (2*length), file=sys.stdout) + + # generate random position of the first nucleotide + com = box_offset + np.random.random_sample(3) * box + # comment out to randomise + com = [0,0,0] + + # generate the random direction of the helix + axis = np.random.random_sample(3) + # comment out to randomise + axis = [0,0,1] + axis /= np.sqrt(np.dot(axis, axis)) + + # use the generate function defined above to create + # the position and orientation vector of the strand + if topo == 'ring': + newpositions, newa1s, newa3s = generate_ring(len(line), \ + sequence=seq, dir=axis, start_pos=com, double=True) + else: + newpositions, newa1s, newa3s = generate_strand(len(line), \ + sequence=seq, dir=axis, start_pos=com, double=True) + + # generate a new position for the strand until it does not overlap + # with anything already present + start = timer() + while not add_strands(newpositions, newa1s, newa3s): + com = box_offset + np.random.random_sample(3) * box + axis = np.random.random_sample(3) + axis /= np.sqrt(np.dot(axis, axis)) + if topo == 'ring': + newpositions, newa1s, newa3s = generate_ring(len(line), \ + sequence=seq, dir=axis, start_pos=com, double=True) + else: + newpositions, newa1s, newa3s = generate_strand(len(line), \ + sequence=seq, dir=axis, start_pos=com, double=True) + print("## Trying %i" % i, file=sys.stdout) + end = timer() + print("## Added duplex of %i bases (line %i/%i) in %.2fs, now at %i/%i" % \ + (2*length, i, nlines, end-start, len(positions), nnucl), file=sys.stdout) + + # block for single strands: last argument of the generate function + # is set to 'False' + else: + length = len(line) + seq = [(base_to_number[x]) for x in line] + + myns += 1 + for b in range(length): + basetype.append(seq[b]) + strandnum.append(myns) + + for b in range(length-1): + bondpair = [noffset + b, noffset + b + 1] + bonds.append(bondpair) + if topo == 'ring': + bondpair = [noffset, noffset + length-1] + bonds.append(bondpair) + noffset += length + + + # generate random position of the first nucleotide + com = box_offset + np.random.random_sample(3) * box + # comment out to randomise + com = [-30,0,0] + + # generate the random direction of the helix + axis = np.random.random_sample(3) + # comment out to randomise + axis = [0,0,1] + axis /= np.sqrt(np.dot(axis, axis)) + + print("## Created single strand of %i bases" % length, file=sys.stdout) + if topo == 'ring': + newpositions, newa1s, newa3s = generate_ring(length, \ + sequence=seq, dir=axis, start_pos=com, double=False) + else: + newpositions, newa1s, newa3s = generate_strand(length, \ + sequence=seq, dir=axis, start_pos=com, double=False) + start = timer() + while not add_strands(newpositions, newa1s, newa3s): + com = box_offset + np.random.random_sample(3) * box + axis = np.random.random_sample(3) + axis /= np.sqrt(np.dot(axis, axis)) + if topo == 'ring': + newpositions, newa1s, newa3s = generate_ring(length, \ + sequence=seq, dir=axis, start_pos=com, double=False) + + else: + newpositions, newa1s, newa3s = generate_strand(length, \ + sequence=seq, dir=axis, start_pos=com, double=False) + print("## Trying %i" % (i), file=sys.stdout) + end = timer() + print("## Added single strand of %i bases (line %i/%i) in %.2fs, now at %i/%i" % \ + (length, i, nlines, end-start,len(positions), nnucl), file=sys.stdout) + + i += 1 + + # sanity check + #if not len(positions) == nnucl: + # print(len(positions), nnucl) + # raise AssertionError + nnucl = nnucl + (N_BEADS**2) + nbonds -= 4 + + out.write('# LAMMPS data file\n') + out.write('%d atoms\n' % nnucl) + out.write('%d ellipsoids\n' % nnucl) + out.write('%d bonds\n' % nbonds) + out.write('\n') + out.write('%d atom types\n' %bead_type ) + out.write('1 bond types\n') + out.write('\n') + out.write('# System size\n') + out.write('%f %f xlo xhi\n' % (box_offset,box_offset+box_length)) + out.write('%f %f ylo yhi\n' % (box_offset,box_offset+box_length)) + out.write('%f %f zlo zhi\n' % (0,box_length)) + + #out.write('\n') + #out.write('Masses\n') + #out.write('\n') + #out.write('1 3.1575\n') + #out.write('2 3.1575\n') + #out.write('3 3.1575\n') + #out.write('4 3.1575\n') + #out.write('5 3.1575\n') + + # for each nucleotide print a line under the headers + # Atoms, Velocities, Ellipsoids and Bonds + out.write('\n') + out.write(\ + '# Atom-ID, type, position, molecule-ID, ellipsoid flag, density\n') + out.write('Atoms\n') + out.write('\n') + + for i in range(nnucl): + out.write('%d %d %22.15le %22.15le %22.15le %d 1 1\n' \ + % (i+1, basetype[i], \ + positions[i][0], positions[i][1], positions[i][2], \ + strandnum[i])) + + out.write('\n') + out.write('# Atom-ID, translational, rotational velocity\n') + out.write('Velocities\n') + out.write('\n') + + for i in range(nnucl): + out.write("%d %22.15le %22.15le %22.15le %22.15le %22.15le %22.15le\n" \ + % (i+1,0.0,0.0,0.0,0.0,0.0,0.0)) + + out.write('\n') + out.write('# Atom-ID, shape, quaternion\n') + out.write('Ellipsoids\n') + out.write('\n') + + for i in range(nnucl): + out.write(\ + "%d %22.15le %22.15le %22.15le %22.15le %22.15le %22.15le %22.15le\n" \ + % (i+1,1.1739845031423408,1.1739845031423408,1.1739845031423408, \ + quaternions[i][0],quaternions[i][1], quaternions[i][2],quaternions[i][3])) + + out.write('\n') + out.write('# Bond topology\n') + out.write('Bonds\n') + out.write('\n') + + for i in range(nbonds): + if i < nbonds-2: + out.write("%d %d %d %d\n" % (i+1,1,bonds[i][0],bonds[i][1])) + #else: + + #out.write("%d %d %d %d\n" % (i+1,2,bonds[i][0],bonds[i][1])) + + out.close() + + print("## Wrote data to 'data.oxdna'", file=sys.stdout) + print("## DONE", file=sys.stdout) + +# call the above main() function, which executes the program +read_strands (infile) + +end_time=timer() +runtime = end_time-start_time +hours = runtime/3600 +minutes = (runtime-np.rint(hours)*3600)/60 +seconds = (runtime-np.rint(hours)*3600-np.rint(minutes)*60)%60 +print("## Total runtime %ih:%im:%.2fs" % (hours,minutes,seconds), file=sys.stdout) diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.4type b/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.4type new file mode 100644 index 0000000000..0570cf042d --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.4type @@ -0,0 +1,94 @@ +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 4 + +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 2.0 bin +neigh_modify every 10 delay 0 check yes + +read_data data.duplex4.4type +mass * 3.1575 + +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.75 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 + +label loop +variable base loop ${ntype} + variable basemod equal ${base}%4 + if "${basemod} == 1" then & + "variable comp equal ${base}+3" & + "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then & + "variable comp equal ${base}+1" & + "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop + +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} 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 + +#write_restart config.${number}.* + + diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.8type b/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.8type new file mode 100644 index 0000000000..dae853a113 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/in.duplex4.8type @@ -0,0 +1,94 @@ +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 8 + +variable T equal 0.1 + +units lj + +dimension 3 + +newton on + +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 10 delay 0 check yes + +read_data data.duplex4.8type +mass * 3.1575 + +group all type 1 8 + +# 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.75 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 + +label loop +variable base loop ${ntype} + variable basemod equal ${base}%4 + if "${basemod} == 1" then & + "variable comp equal ${base}+3" & + "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then & + "variable comp equal ${base}+1" & + "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop + +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} 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 + +#write_restart config.${number}.* + + diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++1 b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++1 new file mode 100644 index 0000000000..d0195dd8e8 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++1 @@ -0,0 +1,232 @@ +LAMMPS (7 Aug 2019) +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 4 + +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 2.0 bin +neigh_modify every 10 delay 0 check yes + +read_data data.duplex4.4type + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 26 atoms + reading velocities ... + 26 velocities + 26 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 24 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 = 6.2e-05 secs + read_data CPU = 0.001124 secs +mass * 3.1575 + +group all type 1 4 +26 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.75 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.75 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 + +label loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 1%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 1+3 +pair_coeff ${base} ${comp} 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 1 ${comp} 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 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 2%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 2+1 +pair_coeff ${base} ${comp} 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 ${comp} 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 +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 3%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 4%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop + +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} 0.2 0.815 +pair_coeff * * oxdna2/dh 0.1 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 0.1 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 10000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +dump out all custom ${ofreq} out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.1.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 +Neighbor list info ... + update every 10 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.63899 + ghost atom cutoff = 5.63899 + binsize = 2.81949, bins = 15 15 15 + 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.89 | 3.89 | 3.89 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.6384018 0.037304147 -1.6010976 6.7769766e-05 +10000 ekin = 1.01296379553452 | erot = 1.38476360245491 | epot = -41.9785360036035 | etot = -39.5808086056141 +20000 ekin = 1.75607695499755 | erot = 1.86620102096623 | epot = -41.9558496477913 | etot = -38.3335716718275 +30000 ekin = 2.25878673688255 | erot = 2.60035907744906 | epot = -41.2869827431736 | etot = -36.427836928842 +40000 ekin = 2.11105717434601 | erot = 3.16611217122795 | epot = -40.2762731426449 | etot = -34.999103797071 +50000 ekin = 3.05379083545185 | erot = 2.45050275456902 | epot = -40.3032957287999 | etot = -34.799002138779 +60000 ekin = 3.05154113920288 | erot = 2.52539576708931 | epot = -39.6800099891302 | etot = -34.103073082838 +70000 ekin = 3.23212209366503 | erot = 3.28914763888578 | epot = -40.1240667487288 | etot = -33.602797016178 +80000 ekin = 2.82623224207568 | erot = 2.91292948677805 | epot = -39.0983962904507 | etot = -33.3592345615969 +90000 ekin = 3.05995314905566 | erot = 3.5429982411034 | epot = -39.1646070343971 | etot = -32.561655644238 +100000 ekin = 3.46139546969836 | erot = 4.11704803295073 | epot = -38.5124679837256 | etot = -30.9340244810765 + 100000 0.092303879 -1.5243833 0.043134544 -1.3481182 6.862374e-06 +Loop time of 7.99505 on 1 procs for 100000 steps with 26 atoms + +Performance: 108066.893 tau/day, 12507.742 timesteps/s +99.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 | 7.2072 | 7.2072 | 7.2072 | 0.0 | 90.15 +Bond | 0.14292 | 0.14292 | 0.14292 | 0.0 | 1.79 +Neigh | 1.9e-05 | 1.9e-05 | 1.9e-05 | 0.0 | 0.00 +Comm | 0.015676 | 0.015676 | 0.015676 | 0.0 | 0.20 +Output | 0.001372 | 0.001372 | 0.001372 | 0.0 | 0.02 +Modify | 0.61071 | 0.61071 | 0.61071 | 0.0 | 7.64 +Other | | 0.01714 | | | 0.21 + +Nlocal: 26 ave 26 max 26 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: 325 ave 325 max 325 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 325 +Ave neighs/atom = 12.5 +Ave special neighs/atom = 5.07692 +Neighbor list builds = 1 +Dangerous builds = 0 + +#write_restart config.${number}.* + + +Total wall time: 0:00:07 diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++4 b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++4 new file mode 100644 index 0000000000..a5647ccd77 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.4type.g++4 @@ -0,0 +1,232 @@ +LAMMPS (7 Aug 2019) +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 4 + +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 2.0 bin +neigh_modify every 10 delay 0 check yes + +read_data data.duplex4.4type + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 26 atoms + reading velocities ... + 26 velocities + 26 ellipsoids + scanning bonds ... + 2 = max bonds/atom + reading bonds ... + 24 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.000173 secs + read_data CPU = 0.00242 secs +mass * 3.1575 + +group all type 1 4 +26 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.75 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.75 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 + +label loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 1%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 1+3 +pair_coeff ${base} ${comp} 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 1 ${comp} 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 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 2%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 2+1 +pair_coeff ${base} ${comp} 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 ${comp} 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 +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 3%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop +variable base loop ${ntype} +variable base loop 4 + variable basemod equal ${base}%4 + variable basemod equal 4%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.4type loop + +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} 0.2 0.815 +pair_coeff * * oxdna2/dh 0.1 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 0.1 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 10000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +dump out all custom ${ofreq} out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.1.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 +Neighbor list info ... + update every 10 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.63899 + ghost atom cutoff = 5.63899 + binsize = 2.81949, bins = 15 15 15 + 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) = 9.499 | 9.682 | 9.864 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.6384018 0.037304147 -1.6010976 6.7769766e-05 +10000 ekin = 1.20524984175817 | erot = 1.2679122962101 | epot = -41.9183873815797 | etot = -39.4452252436114 +20000 ekin = 1.60856540355485 | erot = 2.64140880508964 | epot = -41.0106168994545 | etot = -36.76064269081 +30000 ekin = 2.821101638199 | erot = 3.06373823252434 | epot = -40.9348041675027 | etot = -35.0499642967793 +40000 ekin = 2.36296917392486 | erot = 3.53353555114673 | epot = -39.5591676362755 | etot = -33.6626629112039 +50000 ekin = 2.93383938780818 | erot = 3.39920211088179 | epot = -40.3602175538497 | etot = -34.0271760551597 +60000 ekin = 2.42811021532829 | erot = 2.75130045540831 | epot = -39.3178531324554 | etot = -34.1384424617188 +70000 ekin = 2.7282200818863 | erot = 3.76502037022117 | epot = -40.5673105068195 | etot = -34.074070054712 +80000 ekin = 2.90877851656705 | erot = 2.43617899356904 | epot = -38.4099618426175 | etot = -33.0650043324814 +90000 ekin = 3.89203816080263 | erot = 2.67194811393274 | epot = -39.1880466354802 | etot = -32.6240603607448 +100000 ekin = 3.98445325397832 | erot = 2.77079124049636 | epot = -39.2805505658488 | etot = -32.5253060713741 + 100000 0.10625209 -1.5603519 0.049561514 -1.3575422 -1.7755557e-05 +Loop time of 7.14827 on 4 procs for 100000 steps with 26 atoms + +Performance: 120868.376 tau/day, 13989.395 timesteps/s +99.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.047776 | 3.0726 | 6.3143 | 172.8 | 42.98 +Bond | 0.00736 | 0.056846 | 0.10864 | 20.7 | 0.80 +Neigh | 1.9e-05 | 1.9e-05 | 1.9e-05 | 0.0 | 0.00 +Comm | 0.30925 | 3.451 | 6.3739 | 157.5 | 48.28 +Output | 0.000896 | 0.0010197 | 0.001301 | 0.5 | 0.01 +Modify | 0.015512 | 0.18417 | 0.37845 | 39.4 | 2.58 +Other | | 0.3826 | | | 5.35 + +Nlocal: 6.5 ave 13 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 19.5 ave 26 max 13 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 123.5 ave 247 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 494 +Ave neighs/atom = 19 +Ave special neighs/atom = 5.07692 +Neighbor list builds = 1 +Dangerous builds = 0 + +#write_restart config.${number}.* + + +Total wall time: 0:00:07 diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++1 b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++1 new file mode 100644 index 0000000000..c93943a4c7 --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++1 @@ -0,0 +1,274 @@ +LAMMPS (7 Aug 2019) +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 8 + +variable T equal 0.1 + +units lj + +dimension 3 + +newton on + +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 10 delay 0 check yes + +read_data data.duplex4.8type + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 1 by 1 MPI processor grid + reading atoms ... + 26 atoms + reading velocities ... + 26 velocities + 26 ellipsoids + scanning bonds ... + 1 = max bonds/atom + reading bonds ... + 24 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 = 6.5e-05 secs + read_data CPU = 0.001139 secs +mass * 3.1575 + +group all type 1 8 +26 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.75 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.75 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 + +label loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 1%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 1+3 +pair_coeff ${base} ${comp} 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 1 ${comp} 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 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 2%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 2+1 +pair_coeff ${base} ${comp} 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 ${comp} 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 +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 3%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 4%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 5%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 5+3 +pair_coeff ${base} ${comp} 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 5 ${comp} 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 5 8 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 6%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 6+1 +pair_coeff ${base} ${comp} 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 6 ${comp} 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 6 7 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 +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 7%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 8%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop + +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} 0.2 0.815 +pair_coeff * * oxdna2/dh 0.1 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 0.1 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 10000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +dump out all custom ${ofreq} out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.1.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 +Neighbor list info ... + update every 10 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.63899 + ghost atom cutoff = 4.63899 + binsize = 2.31949, bins = 18 18 18 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 3.905 | 3.905 | 3.905 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.6384018 0.037304147 -1.6010976 6.7769766e-05 +10000 ekin = 1.0129637955345 | erot = 1.38476360245492 | epot = -41.9785360036034 | etot = -39.580808605614 +20000 ekin = 1.75607695499755 | erot = 1.86620102096618 | epot = -41.9558496477911 | etot = -38.3335716718274 +30000 ekin = 2.25878673688259 | erot = 2.60035907744898 | epot = -41.2869827431736 | etot = -36.427836928842 +40000 ekin = 2.11105717434584 | erot = 3.16611217122799 | epot = -40.2762731426449 | etot = -34.9991037970711 +50000 ekin = 3.05379083545187 | erot = 2.45050275456888 | epot = -40.3032957287998 | etot = -34.7990021387791 +60000 ekin = 3.05154113920291 | erot = 2.5253957670889 | epot = -39.6800099891299 | etot = -34.1030730828381 +70000 ekin = 3.23212209366464 | erot = 3.28914763888543 | epot = -40.1240667487278 | etot = -33.6027970161777 +80000 ekin = 2.82623224207591 | erot = 2.91292948677732 | epot = -39.0983962904496 | etot = -33.3592345615963 +90000 ekin = 3.05995314905694 | erot = 3.54299824110274 | epot = -39.164607034397 | etot = -32.5616556442373 +100000 ekin = 3.46139546969892 | erot = 4.11704803295143 | epot = -38.512467983727 | etot = -30.9340244810767 + 100000 0.092303879 -1.5243833 0.043134544 -1.3481182 6.862374e-06 +Loop time of 7.94086 on 1 procs for 100000 steps with 26 atoms + +Performance: 108804.336 tau/day, 12593.094 timesteps/s +99.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 | 7.1507 | 7.1507 | 7.1507 | 0.0 | 90.05 +Bond | 0.14487 | 0.14487 | 0.14487 | 0.0 | 1.82 +Neigh | 6.4e-05 | 6.4e-05 | 6.4e-05 | 0.0 | 0.00 +Comm | 0.032259 | 0.032259 | 0.032259 | 0.0 | 0.41 +Output | 0.003484 | 0.003484 | 0.003484 | 0.0 | 0.04 +Modify | 0.59013 | 0.59013 | 0.59013 | 0.0 | 7.43 +Other | | 0.01934 | | | 0.24 + +Nlocal: 26 ave 26 max 26 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: 323 ave 323 max 323 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 323 +Ave neighs/atom = 12.4231 +Ave special neighs/atom = 5.07692 +Neighbor list builds = 4 +Dangerous builds = 0 + +#write_restart config.${number}.* + + +Total wall time: 0:00:07 diff --git a/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++4 b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++4 new file mode 100644 index 0000000000..5cda079e9c --- /dev/null +++ b/examples/USER/cgdna/examples/oxDNA2/unique_bp/log.07Aug19.duplex4.8type.g++4 @@ -0,0 +1,274 @@ +LAMMPS (7 Aug 2019) +variable number equal 1 +variable ofreq equal 10000 +variable efreq equal 10000 + +variable ntype equal 8 + +variable T equal 0.1 + +units lj + +dimension 3 + +newton on + +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 10 delay 0 check yes + +read_data data.duplex4.8type + orthogonal box = (-20 -20 -20) to (20 20 20) + 1 by 2 by 2 MPI processor grid + reading atoms ... + 26 atoms + reading velocities ... + 26 velocities + 26 ellipsoids + scanning bonds ... + 1 = max bonds/atom + reading bonds ... + 24 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.000232 secs + read_data CPU = 0.002447 secs +mass * 3.1575 + +group all type 1 8 +26 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.75 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.75 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 + +label loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 1%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 1+3 +pair_coeff ${base} ${comp} 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 1 ${comp} 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 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 2%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 2+1 +pair_coeff ${base} ${comp} 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 ${comp} 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 +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 3%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 4%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 5%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+3 +variable comp equal 5+3 +pair_coeff ${base} ${comp} 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 5 ${comp} 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 5 8 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 + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 6%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +variable comp equal ${base}+1 +variable comp equal 6+1 +pair_coeff ${base} ${comp} 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 6 ${comp} 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 6 7 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 +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 7%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop +variable base loop ${ntype} +variable base loop 8 + variable basemod equal ${base}%4 + variable basemod equal 8%4 + if "${basemod} == 1" then "variable comp equal ${base}+3" "pair_coeff ${base} ${comp} 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" + if "${basemod} == 2" then "variable comp equal ${base}+1" "pair_coeff ${base} ${comp} 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" +next base +jump in.duplex4.8type loop + +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} 0.2 0.815 +pair_coeff * * oxdna2/dh 0.1 0.2 0.815 + +# Langevin dynamics +fix 1 all nve/asphere +fix 2 all langevin ${T} ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 ${T} 25.0 457145 angmom 10 +fix 2 all langevin 0.1 0.1 25.0 457145 angmom 10 + +timestep 1e-4 + +#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 10000 "$(step) ekin = ${ekin} | erot = ${erot} | epot = ${epot} | etot = ${etot}" screen yes + +dump out all custom ${ofreq} out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.${number}.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump out all custom 10000 out.1.txt id mol type x y z ix iy iz c_quat[1] c_quat[2] c_quat[3] c_quat[4] vx vy vz +dump_modify out sort id +dump_modify out format line "%d %d %d %13.6le %13.6le %13.6le %d %d %d %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le %13.6le " + +#restart 10000 config0_restart config1_restart + +run 100000 +Neighbor list info ... + update every 10 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 4.63899 + ghost atom cutoff = 4.63899 + binsize = 2.31949, bins = 18 18 18 + 6 neighbor lists, perpetual/occasional/extra = 6 0 0 + (1) pair oxdna2/excv, perpetual + attributes: half, newton on + pair build: half/bin/newton + stencil: half/bin/3d/newton + bin: standard + (2) pair oxdna2/stk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (3) pair oxdna2/hbond, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (4) pair oxdna2/xstk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (5) pair oxdna2/coaxstk, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none + (6) pair oxdna2/dh, perpetual, copy from (1) + attributes: half, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 9.381 | 9.563 | 9.746 Mbytes +Step Temp E_pair E_mol TotEng Press + 0 0 -1.6384018 0.037304147 -1.6010976 6.7769766e-05 +10000 ekin = 1.20524984175816 | erot = 1.26791229621008 | epot = -41.9183873815797 | etot = -39.4452252436115 +20000 ekin = 1.6085654035548 | erot = 2.6414088050897 | epot = -41.0106168994546 | etot = -36.7606426908101 +30000 ekin = 2.82110163819891 | erot = 3.06373823252419 | epot = -40.9348041675026 | etot = -35.0499642967795 +40000 ekin = 2.35553603700794 | erot = 3.60405945883761 | epot = -39.5418687902286 | etot = -33.5822732943831 +50000 ekin = 3.06061403125833 | erot = 3.35548669087246 | epot = -40.3236585928169 | etot = -33.9075578706861 +60000 ekin = 2.7347216991605 | erot = 4.23926242244084 | epot = -39.5379959923263 | etot = -32.564011870725 +70000 ekin = 3.46562604991873 | erot = 2.8521307045909 | epot = -38.7237000550356 | etot = -32.4059433005259 +80000 ekin = 3.17815543267806 | erot = 3.11078099027451 | epot = -39.7525036398366 | etot = -33.463567216884 +90000 ekin = 3.51635117668857 | erot = 2.58384069017333 | epot = -39.4762533092413 | etot = -33.3760614423795 +100000 ekin = 3.64218174280962 | erot = 2.88607181210736 | epot = -37.6002449519119 | etot = -31.0719913969949 + 100000 0.097124846 -1.5164679 0.070304678 -1.3060794 -2.9111933e-05 +Loop time of 5.64462 on 4 procs for 100000 steps with 26 atoms + +Performance: 153066.031 tau/day, 17715.976 timesteps/s +99.0% 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.069668 | 2.1601 | 4.2189 | 138.7 | 38.27 +Bond | 0.008542 | 0.052544 | 0.095929 | 18.7 | 0.93 +Neigh | 4.8e-05 | 5.6e-05 | 6.4e-05 | 0.0 | 0.00 +Comm | 0.90402 | 3.1443 | 5.4155 | 124.9 | 55.70 +Output | 0.001003 | 0.0011317 | 0.001468 | 0.6 | 0.02 +Modify | 0.021098 | 0.20024 | 0.38154 | 39.2 | 3.55 +Other | | 0.0863 | | | 1.53 + +Nlocal: 6.5 ave 13 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 17.5 ave 22 max 13 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Neighs: 80.25 ave 167 max 0 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 321 +Ave neighs/atom = 12.3462 +Ave special neighs/atom = 5.07692 +Neighbor list builds = 3 +Dangerous builds = 0 + +#write_restart config.${number}.* + + +Total wall time: 0:00:05 From 0346a3d6d189642a569741d06630835a4feb3c58 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 15 Nov 2019 10:53:39 -0700 Subject: [PATCH 433/557] Commit JT 111519 - add README file to the benchmark examples repo - removed comments from src/SPIN files --- examples/SPIN/README | 16 +- examples/SPIN/benchmark/README | 47 + .../benchmarck_damped_exchange/res_lammps.dat | 3001 -- .../benchmarck_damped_exchange/res_llg.dat | 30000 ---------------- .../bench-spin-precession.in | 5 +- .../llg_precession.py | 5 +- .../plot_precession.py | 16 +- .../bench-exchange-spin.template | 41 - .../langevin-exchange.py | 34 - .../plot_exchange.py | 34 - .../run-bench-exchange.sh | 28 - .../bench-prec-spin.template | 4 +- .../run-bench-prec.sh | 6 +- src/SPIN/compute_spin.cpp | 2 - src/SPIN/fix_precession_spin.cpp | 20 +- src/SPIN/pair_spin_exchange.cpp | 6 - 16 files changed, 86 insertions(+), 33179 deletions(-) create mode 100644 examples/SPIN/benchmark/README delete mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat delete mode 100644 examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat delete mode 100644 examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template delete mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py delete mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py delete mode 100755 examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh diff --git a/examples/SPIN/README b/examples/SPIN/README index 5ad252e7f2..affb1237f8 100644 --- a/examples/SPIN/README +++ b/examples/SPIN/README @@ -1,20 +1,24 @@ This directory contains examples and applications of the SPIN package ===================================================================== +- the benchmark directory provides comparison between LAMMPS + results and a series of simple test problems (coded as python + scripts). + - the iron, cobalt_hcp, cobalt_fcc and nickel directories provide -examples of spin-lattice calculations. + examples of spin-lattice calculations. - the bfo repository provides an example of spin dynamics calculation -performed on a fixed lattice, and applied to the multiferroic -material bismuth-oxide. + performed on a fixed lattice, and applied to the multiferroic + material bismuth-oxide. - the read_restart directory provides examples allowing to write or -read data files, and restart magneto-mechanical simulations. + read data files, and restart magneto-mechanical simulations. - vizualization of the dump files can be achieved using Ovito or -VMD. See the vmd repository for help vizualizing results with VMD. + VMD. See the vmd repository for help vizualizing results with VMD. ** Note, the aim of this repository is mainly to provide users with examples. Better values and tuning of the magnetic and mechanical -interactions can be achieved for more accurate materials +interactions can (have to...) be achieved for more accurate materials simulations. ** diff --git a/examples/SPIN/benchmark/README b/examples/SPIN/benchmark/README new file mode 100644 index 0000000000..5557e3d42b --- /dev/null +++ b/examples/SPIN/benchmark/README @@ -0,0 +1,47 @@ +** The objective of the benchmark examples in this directory + is the following twofold: +- verify the implementation of the LAMMPS' SPIN package by + comparing its results to well-known analytic results, or + to simple test problems, +- provide users with simple comparisons, allowing them to + better understand what is implemented in the code. + +The LAMMPS input file (bench-*) can be modified, as well as the +associated python script, in order to try different comparisons. + +All scripts can be run by executing the shell script from its +directory. Example: +./run-bench-exchange.sh from the benchmarck_damped_exchange/ +directory. + +** Below a brief description of the different benchmark + problems: + +- benchmarck_damped_precession: + simulates the damped precession of a single spin in a magnetic + field. + Run as: ./run-bench-prec.sh + Output: x, y and z components of the magnetization, and + magnetic energy. + +- benchmarck_damped_exchange: + simulates two spins interacting through the exchange + interaction. The parameters in the LAMMPS input script + (bench-spin-precession.in) are calibrated to match the + exchange definition in the python script (llg_exchange.py). + Run as: ./run-bench-exchange.sh + Output: average magnetization resulting from the damped + precession of the two interacting spins. Also plots the + evolution of the magnetic energy. + +- benchmarck_langevin_precession: + simulates a single spin in a magnetic field and in contact + with a thermal bath, and compares the statistical averages of + the output to the analytical result of the Langevin function. + Run as: ./run-bench-prec.sh + Output: statistical average of the z-component of the + magnetization (along the applied field) and of the magnetic + energy versus temperature. Comparison to the Langevin function + results (computed by the python script). + Note: This example is a reworked version of a test problem + provided by Martin Kroger (ETHZ). diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat deleted file mode 100644 index aa331f50ea..0000000000 --- a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_lammps.dat +++ /dev/null @@ -1,3001 +0,0 @@ - 0 0 0.5 0.5 0 0 0 0 - 10 0.001 0.50037967 0.50037966 6.8386474e-08 -0.00015191886 -0.00015191886 -0.00015191886 - 20 0.002 0.50075905 0.50075902 1.3603286e-07 -0.00030383701 -0.00030383701 -0.00030383701 - 30 0.003 0.50113814 0.50113809 2.0215189e-07 -0.00045575377 -0.00045575377 -0.00045575377 - 40 0.004 0.50151695 0.50151686 2.6596985e-07 -0.00060766842 -0.00060766842 -0.00060766842 - 50 0.005 0.50189547 0.50189534 3.2673578e-07 -0.00075958028 -0.00075958028 -0.00075958028 - 60 0.006 0.5022737 0.50227351 3.8373034e-07 -0.00091148862 -0.00091148862 -0.00091148862 - 70 0.007 0.50265165 0.50265139 4.3627448e-07 -0.0010633928 -0.0010633928 -0.0010633928 - 80 0.008 0.50302929 0.50302897 4.8373764e-07 -0.001215292 -0.001215292 -0.001215292 - 90 0.009 0.50340665 0.50340624 5.2554551e-07 -0.0013671856 -0.0013671856 -0.0013671856 - 100 0.01 0.50378371 0.50378322 5.6118711e-07 -0.001519073 -0.001519073 -0.001519073 - 110 0.011 0.50416047 0.50415989 5.9022131e-07 -0.0016709533 -0.0016709533 -0.0016709533 - 120 0.012 0.50453694 0.50453626 6.1228239e-07 -0.0018228259 -0.0018228259 -0.0018228259 - 130 0.013 0.5049131 0.50491233 6.2708498e-07 -0.0019746901 -0.0019746901 -0.0019746901 - 140 0.014 0.50528896 0.50528809 6.3442788e-07 -0.0021265452 -0.0021265452 -0.0021265452 - 150 0.015 0.50566452 0.50566355 6.3419702e-07 -0.0022783904 -0.0022783904 -0.0022783904 - 160 0.016 0.50603978 0.50603871 6.2636743e-07 -0.0024302252 -0.0024302252 -0.0024302252 - 170 0.017 0.50641473 0.50641356 6.1100409e-07 -0.0025820488 -0.0025820488 -0.0025820488 - 180 0.018 0.50678937 0.50678811 5.8826175e-07 -0.0027338604 -0.0027338604 -0.0027338604 - 190 0.019 0.5071637 0.50716235 5.5838372e-07 -0.0028856595 -0.0028856595 -0.0028856595 - 200 0.02 0.50753772 0.50753628 5.2169947e-07 -0.0030374452 -0.0030374452 -0.0030374452 - 210 0.021 0.50791142 0.50790991 4.7862136e-07 -0.0031892169 -0.0031892169 -0.0031892169 - 220 0.022 0.50828482 0.50828322 4.2964016e-07 -0.0033409739 -0.0033409739 -0.0033409739 - 230 0.023 0.50865789 0.50865624 3.7531975e-07 -0.0034927156 -0.0034927156 -0.0034927156 - 240 0.024 0.50903065 0.50902894 3.1629077e-07 -0.0036444411 -0.0036444411 -0.0036444411 - 250 0.025 0.50940309 0.50940133 2.5324353e-07 -0.0037961498 -0.0037961498 -0.0037961498 - 260 0.026 0.50977521 0.50977342 1.8692008e-07 -0.003947841 -0.003947841 -0.003947841 - 270 0.027 0.51014701 0.51014519 1.1810555e-07 -0.0040995141 -0.0040995141 -0.0040995141 - 280 0.028 0.51051849 0.51051665 4.7619044e-08 -0.0042511682 -0.0042511682 -0.0042511682 - 290 0.029 0.51088964 0.5108878 -2.3696119e-08 -0.0044028027 -0.0044028027 -0.0044028027 - 300 0.03 0.51126047 0.51125863 -9.4982408e-08 -0.004554417 -0.004554417 -0.004554417 - 310 0.031 0.51163097 0.51162915 -1.653784e-07 -0.0047060103 -0.0047060103 -0.0047060103 - 320 0.032 0.51200115 0.51199936 -2.3402922e-07 -0.0048575819 -0.0048575819 -0.0048575819 - 330 0.033 0.512371 0.51236925 -3.0009692e-07 -0.0050091312 -0.0050091312 -0.0050091312 - 340 0.034 0.51274052 0.51273882 -3.6277088e-07 -0.0051606574 -0.0051606574 -0.0051606574 - 350 0.035 0.51310971 0.51310807 -4.2127775e-07 -0.0053121598 -0.0053121598 -0.0053121598 - 360 0.036 0.51347857 0.513477 -4.7489123e-07 -0.0054636378 -0.0054636378 -0.0054636378 - 370 0.037 0.51384711 0.51384561 -5.2294115e-07 -0.0056150906 -0.0056150906 -0.0056150906 - 380 0.038 0.51421531 0.51421389 -5.6482212e-07 -0.0057665177 -0.0057665177 -0.0057665177 - 390 0.039 0.51458318 0.51458185 -6.0000127e-07 -0.0059179181 -0.0059179181 -0.0059179181 - 400 0.04 0.51495072 0.51494949 -6.2802531e-07 -0.0060692914 -0.0060692914 -0.0060692914 - 410 0.041 0.51531793 0.51531679 -6.4852657e-07 -0.0062206367 -0.0062206367 -0.0062206367 - 420 0.042 0.51568481 0.51568377 -6.6122807e-07 -0.0063719535 -0.0063719535 -0.0063719535 - 430 0.043 0.51605135 0.51605041 -6.659475e-07 -0.0065232409 -0.0065232409 -0.0065232409 - 440 0.044 0.51641756 0.51641673 -6.6260004e-07 -0.0066744984 -0.0066744984 -0.0066744984 - 450 0.045 0.51678344 0.51678271 -6.5120005e-07 -0.0068257252 -0.0068257252 -0.0068257252 - 460 0.046 0.51714898 0.51714835 -6.3186146e-07 -0.0069769206 -0.0069769206 -0.0069769206 - 470 0.047 0.51751419 0.51751365 -6.0479702e-07 -0.007128084 -0.007128084 -0.007128084 - 480 0.048 0.51787906 0.51787862 -5.7031623e-07 -0.0072792147 -0.0072792147 -0.0072792147 - 490 0.049 0.51824361 0.51824324 -5.2882208e-07 -0.0074303119 -0.0074303119 -0.0074303119 - 500 0.05 0.51860781 0.51860753 -4.8080667e-07 -0.0075813751 -0.0075813751 -0.0075813751 - 510 0.051 0.51897168 0.51897147 -4.2684553e-07 -0.0077324034 -0.0077324034 -0.0077324034 - 520 0.052 0.51933522 0.51933506 -3.6759103e-07 -0.0078833963 -0.0078833963 -0.0078833963 - 530 0.053 0.51969841 0.51969831 -3.0376461e-07 -0.008034353 -0.008034353 -0.008034353 - 540 0.054 0.52006127 0.52006121 -2.3614824e-07 -0.0081852728 -0.0081852728 -0.0081852728 - 550 0.055 0.5204238 0.52042377 -1.6557495e-07 -0.0083361551 -0.0083361551 -0.0083361551 - 560 0.056 0.52078598 0.52078597 -9.2918676e-08 -0.0084869992 -0.0084869992 -0.0084869992 - 570 0.057 0.52114783 0.52114782 -1.9083552e-08 -0.0086378045 -0.0086378045 -0.0086378045 - 580 0.058 0.52150933 0.52150932 5.5007325e-08 -0.0087885701 -0.0087885701 -0.0087885701 - 590 0.059 0.5218705 0.52187047 1.2842339e-07 -0.0089392955 -0.0089392955 -0.0089392955 - 600 0.06 0.52223132 0.52223127 2.0023832e-07 -0.00908998 -0.00908998 -0.00908998 - 610 0.061 0.5225918 0.52259171 2.6954176e-07 -0.0092406228 -0.0092406228 -0.0092406228 - 620 0.062 0.52295193 0.52295179 3.3545095e-07 -0.0093912234 -0.0093912234 -0.0093912234 - 630 0.063 0.52331172 0.52331152 3.9712206e-07 -0.009541781 -0.009541781 -0.009541781 - 640 0.064 0.52367116 0.52367089 4.5376114e-07 -0.0096922949 -0.0096922949 -0.0096922949 - 650 0.065 0.52403026 0.52402991 5.046345e-07 -0.0098427645 -0.0098427645 -0.0098427645 - 660 0.066 0.52438901 0.52438857 5.4907839e-07 -0.0099931892 -0.0099931892 -0.0099931892 - 670 0.067 0.5247474 0.52474687 5.8650789e-07 -0.010143568 -0.010143568 -0.010143568 - 680 0.068 0.52510544 0.52510482 6.1642481e-07 -0.010293901 -0.010293901 -0.010293901 - 690 0.069 0.52546313 0.52546241 6.3842457e-07 -0.010444186 -0.010444186 -0.010444186 - 700 0.07 0.52582047 0.52581964 6.5220194e-07 -0.010594424 -0.010594424 -0.010594424 - 710 0.071 0.52617745 0.52617651 6.5755549e-07 -0.010744614 -0.010744614 -0.010744614 - 720 0.072 0.52653407 0.52653302 6.5439079e-07 -0.010894754 -0.010894754 -0.010894754 - 730 0.073 0.52689033 0.52688917 6.4272228e-07 -0.011044845 -0.011044845 -0.011044845 - 740 0.074 0.52724622 0.52724497 6.2267365e-07 -0.011194886 -0.011194886 -0.011194886 - 750 0.075 0.52760176 0.5276004 5.944769e-07 -0.011344875 -0.011344875 -0.011344875 - 760 0.076 0.52795693 0.52795548 5.5847e-07 -0.011494813 -0.011494813 -0.011494813 - 770 0.077 0.52831174 0.5283102 5.1509307e-07 -0.011644699 -0.011644699 -0.011644699 - 780 0.078 0.52866618 0.52866456 4.6488335e-07 -0.011794531 -0.011794531 -0.011794531 - 790 0.079 0.52902025 0.52901855 4.0846871e-07 -0.01194431 -0.01194431 -0.01194431 - 800 0.08 0.52937395 0.52937219 3.465601e-07 -0.012094034 -0.012094034 -0.012094034 - 810 0.081 0.52972728 0.52972547 2.7994273e-07 -0.012243703 -0.012243703 -0.012243703 - 820 0.082 0.53008023 0.53007838 2.0946635e-07 -0.012393317 -0.012393317 -0.012393317 - 830 0.083 0.53043282 0.53043093 1.3603449e-07 -0.012542874 -0.012542874 -0.012542874 - 840 0.084 0.53078503 0.53078313 6.0593014e-08 -0.012692375 -0.012692375 -0.012692375 - 850 0.085 0.53113686 0.53113495 -1.5881986e-08 -0.012841818 -0.012841818 -0.012841818 - 860 0.086 0.53148832 0.53148642 -9.2396775e-08 -0.012991202 -0.012991202 -0.012991202 - 870 0.087 0.5318394 0.53183752 -1.6795288e-07 -0.013140528 -0.013140528 -0.013140528 - 880 0.088 0.5321901 0.53218825 -2.4156016e-07 -0.013289793 -0.013289793 -0.013289793 - 890 0.089 0.53254043 0.53253862 -3.1224982e-07 -0.013438999 -0.013438999 -0.013438999 - 900 0.09 0.53289037 0.53288862 -3.7908725e-07 -0.013588144 -0.013588144 -0.013588144 - 910 0.091 0.53323994 0.53323825 -4.4118454e-07 -0.013737227 -0.013737227 -0.013737227 - 920 0.092 0.53358913 0.53358751 -4.977124e-07 -0.013886248 -0.013886248 -0.013886248 - 930 0.093 0.53393793 0.5339364 -5.4791141e-07 -0.014035206 -0.014035206 -0.014035206 - 940 0.094 0.53428636 0.53428492 -5.9110247e-07 -0.0141841 -0.0141841 -0.0141841 - 950 0.095 0.53463441 0.53463306 -6.2669617e-07 -0.014332931 -0.014332931 -0.014332931 - 960 0.096 0.53498207 0.53498083 -6.5420112e-07 -0.014481696 -0.014481696 -0.014481696 - 970 0.097 0.53532936 0.53532822 -6.7323096e-07 -0.014630397 -0.014630397 -0.014630397 - 980 0.098 0.53567626 0.53567523 -6.8351008e-07 -0.014779031 -0.014779031 -0.014779031 - 990 0.099 0.53602279 0.53602186 -6.8487786e-07 -0.014927598 -0.014927598 -0.014927598 - 1000 0.1 0.53636893 0.53636812 -6.7729144e-07 -0.015076098 -0.015076098 -0.015076098 - 1010 0.101 0.53671469 0.53671399 -6.6082695e-07 -0.01522453 -0.01522453 -0.01522453 - 1020 0.102 0.53706008 0.53705947 -6.3567905e-07 -0.015372893 -0.015372893 -0.015372893 - 1030 0.103 0.53740508 0.53740457 -6.0215905e-07 -0.015521187 -0.015521187 -0.015521187 - 1040 0.104 0.5377497 0.53774928 -5.6069133e-07 -0.015669411 -0.015669411 -0.015669411 - 1050 0.105 0.53809394 0.53809361 -5.1180824e-07 -0.015817565 -0.015817565 -0.015817565 - 1060 0.106 0.53843779 0.53843754 -4.5614357e-07 -0.015965647 -0.015965647 -0.015965647 - 1070 0.107 0.53878127 0.53878109 -3.9442456e-07 -0.016113658 -0.016113658 -0.016113658 - 1080 0.108 0.53912436 0.53912424 -3.2746259e-07 -0.016261596 -0.016261596 -0.016261596 - 1090 0.109 0.53946708 0.539467 -2.5614276e-07 -0.016409461 -0.016409461 -0.016409461 - 1100 0.11 0.53980941 0.53980936 -1.8141231e-07 -0.016557252 -0.016557252 -0.016557252 - 1110 0.111 0.54015135 0.54015133 -1.0426816e-07 -0.016704969 -0.016704969 -0.016704969 - 1120 0.112 0.54049292 0.54049291 -2.5743734e-08 -0.016852611 -0.016852611 -0.016852611 - 1130 0.113 0.5408341 0.54083408 5.3104867e-08 -0.017000178 -0.017000178 -0.017000178 - 1140 0.114 0.5411749 0.54117486 1.3121303e-07 -0.017147668 -0.017147668 -0.017147668 - 1150 0.115 0.54151531 0.54151524 2.07522e-07 -0.017295081 -0.017295081 -0.017295081 - 1160 0.116 0.54185533 0.54185522 2.8099335e-07 -0.017442417 -0.017442417 -0.017442417 - 1170 0.117 0.54219497 0.54219481 3.5062312e-07 -0.017589675 -0.017589675 -0.017589675 - 1180 0.118 0.54253421 0.54253399 4.1545572e-07 -0.017736854 -0.017736854 -0.017736854 - 1190 0.119 0.54287307 0.54287277 4.7459715e-07 -0.017883954 -0.017883954 -0.017883954 - 1200 0.12 0.54321154 0.54321116 5.2722756e-07 -0.018030974 -0.018030974 -0.018030974 - 1210 0.121 0.54354962 0.54354914 5.7261279e-07 -0.018177914 -0.018177914 -0.018177914 - 1220 0.122 0.5438873 0.54388672 6.1011484e-07 -0.018324772 -0.018324772 -0.018324772 - 1230 0.123 0.54422459 0.54422391 6.3920113e-07 -0.018471549 -0.018471549 -0.018471549 - 1240 0.124 0.54456149 0.54456069 6.5945229e-07 -0.018618243 -0.018618243 -0.018618243 - 1250 0.125 0.54489798 0.54489707 6.7056853e-07 -0.018764854 -0.018764854 -0.018764854 - 1260 0.126 0.54523408 0.54523306 6.723743e-07 -0.018911382 -0.018911382 -0.018911382 - 1270 0.127 0.54556978 0.54556864 6.6482138e-07 -0.019057825 -0.019057825 -0.019057825 - 1280 0.128 0.54590507 0.54590383 6.4799014e-07 -0.019204184 -0.019204184 -0.019204184 - 1290 0.129 0.54623997 0.54623861 6.2208909e-07 -0.019350458 -0.019350458 -0.019350458 - 1300 0.13 0.54657445 0.546573 5.8745262e-07 -0.019496645 -0.019496645 -0.019496645 - 1310 0.131 0.54690854 0.54690699 5.4453703e-07 -0.019642746 -0.019642746 -0.019642746 - 1320 0.132 0.54724221 0.54724057 4.9391474e-07 -0.019788759 -0.019788759 -0.019788759 - 1330 0.133 0.54757548 0.54757376 4.36267e-07 -0.019934685 -0.019934685 -0.019934685 - 1340 0.134 0.54790834 0.54790655 3.7237494e-07 -0.020080523 -0.020080523 -0.020080523 - 1350 0.135 0.54824079 0.54823894 3.0310917e-07 -0.020226271 -0.020226271 -0.020226271 - 1360 0.136 0.54857283 0.54857093 2.2941816e-07 -0.02037193 -0.02037193 -0.02037193 - 1370 0.137 0.54890445 0.54890252 1.5231537e-07 -0.020517499 -0.020517499 -0.020517499 - 1380 0.138 0.54923567 0.54923371 7.2865429e-08 -0.020662978 -0.020662978 -0.020662978 - 1390 0.139 0.54956646 0.5495645 -7.830451e-09 -0.020808364 -0.020808364 -0.020808364 - 1400 0.14 0.54989685 0.54989489 -8.8649727e-08 -0.020953659 -0.020953659 -0.020953659 - 1410 0.141 0.55022681 0.55022488 -1.6846411e-07 -0.021098862 -0.021098862 -0.021098862 - 1420 0.142 0.55055637 0.55055446 -2.4615537e-07 -0.021243971 -0.021243971 -0.021243971 - 1430 0.143 0.5508855 0.55088364 -3.2063102e-07 -0.021388987 -0.021388987 -0.021388987 - 1440 0.144 0.55121422 0.55121242 -3.9083985e-07 -0.021533909 -0.021533909 -0.021533909 - 1450 0.145 0.55154253 0.55154079 -4.5578686e-07 -0.021678736 -0.021678736 -0.021678736 - 1460 0.146 0.55187041 0.55186876 -5.1454752e-07 -0.021823467 -0.021823467 -0.021823467 - 1470 0.147 0.55219788 0.55219632 -5.6628117e-07 -0.021968102 -0.021968102 -0.021968102 - 1480 0.148 0.55252494 0.55252347 -6.1024325e-07 -0.022112641 -0.022112641 -0.022112641 - 1490 0.149 0.55285157 0.55285021 -6.4579628e-07 -0.022257083 -0.022257083 -0.022257083 - 1500 0.15 0.5531778 0.55317654 -6.7241935e-07 -0.022401428 -0.022401428 -0.022401428 - 1510 0.151 0.5535036 0.55350246 -6.8971607e-07 -0.022545674 -0.022545674 -0.022545674 - 1520 0.152 0.55382899 0.55382796 -6.9742076e-07 -0.022689821 -0.022689821 -0.022689821 - 1530 0.153 0.55415396 0.55415305 -6.9540277e-07 -0.022833869 -0.022833869 -0.022833869 - 1540 0.154 0.55447852 0.55447772 -6.8366905e-07 -0.022977817 -0.022977817 -0.022977817 - 1550 0.155 0.55480267 0.55480198 -6.623646e-07 -0.023121664 -0.023121664 -0.023121664 - 1560 0.156 0.5551264 0.55512581 -6.3177108e-07 -0.023265411 -0.023265411 -0.023265411 - 1570 0.157 0.55544971 0.55544923 -5.9230341e-07 -0.023409056 -0.023409056 -0.023409056 - 1580 0.158 0.55577261 0.55577222 -5.4450444e-07 -0.023552599 -0.023552599 -0.023552599 - 1590 0.159 0.5560951 0.55609479 -4.8903776e-07 -0.023696039 -0.023696039 -0.023696039 - 1600 0.16 0.55641717 0.55641694 -4.2667879e-07 -0.023839376 -0.023839376 -0.023839376 - 1610 0.161 0.55673883 0.55673866 -3.5830415e-07 -0.023982609 -0.023982609 -0.023982609 - 1620 0.162 0.55706007 0.55705996 -2.8487954e-07 -0.024125737 -0.024125737 -0.024125737 - 1630 0.163 0.5573809 0.55738083 -2.0744627e-07 -0.024268761 -0.024268761 -0.024268761 - 1640 0.164 0.55770132 0.55770127 -1.2710666e-07 -0.02441168 -0.02441168 -0.02441168 - 1650 0.165 0.55802132 0.55802129 -4.5008398e-08 -0.024554492 -0.024554492 -0.024554492 - 1660 0.166 0.55834091 0.55834087 3.7671735e-08 -0.024697198 -0.024697198 -0.024697198 - 1670 0.167 0.55866008 0.55866003 1.1974475e-07 -0.024839797 -0.024839797 -0.024839797 - 1680 0.168 0.55897883 0.55897876 2.0002656e-07 -0.024982288 -0.024982288 -0.024982288 - 1690 0.169 0.55929717 0.55929705 2.7735509e-07 -0.025124671 -0.025124671 -0.025124671 - 1700 0.17 0.55961509 0.55961492 3.5060722e-07 -0.025266946 -0.025266946 -0.025266946 - 1710 0.171 0.5599326 0.55993235 4.187152e-07 -0.025409111 -0.025409111 -0.025409111 - 1720 0.172 0.56024968 0.56024936 4.8068242e-07 -0.025551167 -0.025551167 -0.025551167 - 1730 0.173 0.56056635 0.56056593 5.3559812e-07 -0.025693112 -0.025693112 -0.025693112 - 1740 0.174 0.56088259 0.56088208 5.8265107e-07 -0.025834947 -0.025834947 -0.025834947 - 1750 0.175 0.56119841 0.5611978 6.2114175e-07 -0.02597667 -0.02597667 -0.02597667 - 1760 0.176 0.56151381 0.56151308 6.5049306e-07 -0.026118282 -0.026118282 -0.026118282 - 1770 0.177 0.56182878 0.56182794 6.7025922e-07 -0.026259781 -0.026259781 -0.026259781 - 1780 0.178 0.56214333 0.56214237 6.8013288e-07 -0.026401167 -0.026401167 -0.026401167 - 1790 0.179 0.56245744 0.56245637 6.7995015e-07 -0.02654244 -0.02654244 -0.02654244 - 1800 0.18 0.56277113 0.56276994 6.6969368e-07 -0.026683599 -0.026683599 -0.026683599 - 1810 0.181 0.56308439 0.56308308 6.4949344e-07 -0.026824644 -0.026824644 -0.026824644 - 1820 0.182 0.56339722 0.5633958 6.1962549e-07 -0.026965574 -0.026965574 -0.026965574 - 1830 0.183 0.56370962 0.56370809 5.8050855e-07 -0.027106388 -0.027106388 -0.027106388 - 1840 0.184 0.56402158 0.56401996 5.326984e-07 -0.027247086 -0.027247086 -0.027247086 - 1850 0.185 0.56433311 0.5643314 4.7688029e-07 -0.027387668 -0.027387668 -0.027387668 - 1860 0.186 0.5646442 0.56464241 4.1385938e-07 -0.027528133 -0.027528133 -0.027528133 - 1870 0.187 0.56495486 0.564953 3.445494e-07 -0.027668481 -0.027668481 -0.027668481 - 1880 0.188 0.56526508 0.56526316 2.6995953e-07 -0.027808711 -0.027808711 -0.027808711 - 1890 0.189 0.56557486 0.5655729 1.9117995e-07 -0.027948822 -0.027948822 -0.027948822 - 1900 0.19 0.5658842 0.56588221 1.0936603e-07 -0.028088814 -0.028088814 -0.028088814 - 1910 0.191 0.5661931 0.5661911 2.5721446e-08 -0.028228687 -0.028228687 -0.028228687 - 1920 0.192 0.56650156 0.56649956 -5.8519431e-08 -0.02836844 -0.02836844 -0.02836844 - 1930 0.193 0.56680958 0.56680759 -1.4210974e-07 -0.028508072 -0.028508072 -0.028508072 - 1940 0.194 0.56711716 0.5671152 -2.2380861e-07 -0.028647584 -0.028647584 -0.028647584 - 1950 0.195 0.5674243 0.56742238 -3.0239963e-07 -0.028786974 -0.028786974 -0.028786974 - 1960 0.196 0.56773099 0.56772914 -3.7670909e-07 -0.028926242 -0.028926242 -0.028926242 - 1970 0.197 0.56803725 0.56803546 -4.456236e-07 -0.029065388 -0.029065388 -0.029065388 - 1980 0.198 0.56834306 0.56834136 -5.0810696e-07 -0.029204411 -0.029204411 -0.029204411 - 1990 0.199 0.56864844 0.56864682 -5.6321599e-07 -0.029343311 -0.029343311 -0.029343311 - 2000 0.2 0.56895337 0.56895185 -6.1011491e-07 -0.029482087 -0.029482087 -0.029482087 - 2010 0.201 0.56925786 0.56925645 -6.4808837e-07 -0.029620739 -0.029620739 -0.029620739 - 2020 0.202 0.56956192 0.56956062 -6.7655256e-07 -0.029759266 -0.029759266 -0.029759266 - 2030 0.203 0.56986553 0.56986435 -6.9506456e-07 -0.029897668 -0.029897668 -0.029897668 - 2040 0.204 0.57016871 0.57016765 -7.0332945e-07 -0.030035944 -0.030035944 -0.030035944 - 2050 0.205 0.57047145 0.5704705 -7.0120542e-07 -0.030174094 -0.030174094 -0.030174094 - 2060 0.206 0.57077375 0.57077292 -6.8870641e-07 -0.030312118 -0.030312118 -0.030312118 - 2070 0.207 0.57107561 0.5710749 -6.6600254e-07 -0.030450014 -0.030450014 -0.030450014 - 2080 0.208 0.57137704 0.57137644 -6.3341814e-07 -0.030587783 -0.030587783 -0.030587783 - 2090 0.209 0.57167803 0.57167754 -5.9142746e-07 -0.030725424 -0.030725424 -0.030725424 - 2100 0.21 0.57197859 0.57197819 -5.4064804e-07 -0.030862936 -0.030862936 -0.030862936 - 2110 0.211 0.57227872 0.5722784 -4.8183194e-07 -0.03100032 -0.03100032 -0.03100032 - 2120 0.212 0.5725784 0.57257817 -4.1585486e-07 -0.031137574 -0.031137574 -0.031137574 - 2130 0.213 0.57287766 0.57287749 -3.4370333e-07 -0.031274698 -0.031274698 -0.031274698 - 2140 0.214 0.57317648 0.57317636 -2.6646013e-07 -0.031411692 -0.031411692 -0.031411692 - 2150 0.215 0.57347487 0.57347478 -1.8528826e-07 -0.031548556 -0.031548556 -0.031548556 - 2160 0.216 0.57377282 0.57377276 -1.0141351e-07 -0.031685288 -0.031685288 -0.031685288 - 2170 0.217 0.57407034 0.57407029 -1.6106051e-08 -0.031821889 -0.031821889 -0.031821889 - 2180 0.218 0.57436743 0.57436736 6.9338743e-08 -0.031958358 -0.031958358 -0.031958358 - 2190 0.219 0.57466408 0.57466399 1.5361998e-07 -0.032094694 -0.032094694 -0.032094694 - 2200 0.22 0.57496029 0.57496017 2.3545107e-07 -0.032230897 -0.032230897 -0.032230897 - 2210 0.221 0.57525608 0.57525591 3.1357945e-07 -0.032366967 -0.032366967 -0.032366967 - 2220 0.222 0.57555142 0.57555119 3.8680589e-07 -0.032502904 -0.032502904 -0.032502904 - 2230 0.223 0.57584633 0.57584602 4.54003e-07 -0.032638706 -0.032638706 -0.032638706 - 2240 0.224 0.5761408 0.57614041 5.1413283e-07 -0.032774373 -0.032774373 -0.032774373 - 2250 0.225 0.57643483 0.57643434 5.6626308e-07 -0.032909906 -0.032909906 -0.032909906 - 2260 0.226 0.57672843 0.57672783 6.0958183e-07 -0.033045303 -0.033045303 -0.033045303 - 2270 0.227 0.57702158 0.57702087 6.4341044e-07 -0.033180564 -0.033180564 -0.033180564 - 2280 0.228 0.5773143 0.57731347 6.6721445e-07 -0.033315689 -0.033315689 -0.033315689 - 2290 0.229 0.57760657 0.57760562 6.8061239e-07 -0.033450677 -0.033450677 -0.033450677 - 2300 0.23 0.57789839 0.57789732 6.8338214e-07 -0.033585528 -0.033585528 -0.033585528 - 2310 0.231 0.57818977 0.57818858 6.7546495e-07 -0.033720241 -0.033720241 -0.033720241 - 2320 0.232 0.57848071 0.5784794 6.5696693e-07 -0.033854817 -0.033854817 -0.033854817 - 2330 0.233 0.5787712 0.57876977 6.2815797e-07 -0.033989254 -0.033989254 -0.033989254 - 2340 0.234 0.57906124 0.5790597 5.8946815e-07 -0.034123552 -0.034123552 -0.034123552 - 2350 0.235 0.57935083 0.57934919 5.4148162e-07 -0.034257711 -0.034257711 -0.034257711 - 2360 0.236 0.57963997 0.57963824 4.8492805e-07 -0.034391731 -0.034391731 -0.034391731 - 2370 0.237 0.57992866 0.57992685 4.2067186e-07 -0.03452561 -0.03452561 -0.03452561 - 2380 0.238 0.5802169 0.58021501 3.496992e-07 -0.03465935 -0.03465935 -0.03465935 - 2390 0.239 0.58050468 0.58050274 2.73103e-07 -0.034792948 -0.034792948 -0.034792948 - 2400 0.24 0.58079201 0.58079003 1.9206639e-07 -0.034926405 -0.034926405 -0.034926405 - 2410 0.241 0.58107889 0.58107688 1.078445e-07 -0.035059721 -0.035059721 -0.035059721 - 2420 0.242 0.58136532 0.58136329 2.1745102e-08 -0.035192895 -0.035192895 -0.035192895 - 2430 0.243 0.58165129 0.58164926 -6.4891571e-08 -0.035325926 -0.035325926 -0.035325926 - 2440 0.244 0.5819368 0.58193479 -1.5071374e-07 -0.035458815 -0.035458815 -0.035458815 - 2450 0.245 0.58222186 0.58221988 -2.3437916e-07 -0.035591561 -0.035591561 -0.035591561 - 2460 0.246 0.58250646 0.58250453 -3.145762e-07 -0.035724163 -0.035724163 -0.035724163 - 2470 0.247 0.58279061 0.58278874 -3.900445e-07 -0.035856621 -0.035856621 -0.035856621 - 2480 0.248 0.58307431 0.58307251 -4.5959495e-07 -0.035988935 -0.035988935 -0.035988935 - 2490 0.249 0.58335755 0.58335584 -5.2212856e-07 -0.036121105 -0.036121105 -0.036121105 - 2500 0.25 0.58364034 0.58363872 -5.7665408e-07 -0.036253129 -0.036253129 -0.036253129 - 2510 0.251 0.58392268 0.58392116 -6.2230397e-07 -0.036385008 -0.036385008 -0.036385008 - 2520 0.252 0.58420456 0.58420316 -6.583484e-07 -0.036516742 -0.036516742 -0.036516742 - 2530 0.253 0.584486 0.58448471 -6.842073e-07 -0.036648329 -0.036648329 -0.036648329 - 2540 0.254 0.58476698 0.58476581 -6.9945994e-07 -0.03677977 -0.03677977 -0.03677977 - 2550 0.255 0.58504751 0.58504647 -7.0385209e-07 -0.036911064 -0.036911064 -0.036911064 - 2560 0.256 0.5853276 0.58532668 -6.9730063e-07 -0.037042211 -0.037042211 -0.037042211 - 2570 0.257 0.58560724 0.58560643 -6.7989533e-07 -0.03717321 -0.03717321 -0.03717321 - 2580 0.258 0.58588642 0.58588574 -6.5189807e-07 -0.037304062 -0.037304062 -0.037304062 - 2590 0.259 0.58616517 0.58616459 -6.1373914e-07 -0.037434765 -0.037434765 -0.037434765 - 2600 0.26 0.58644347 0.586443 -5.66011e-07 -0.03756532 -0.03756532 -0.03756532 - 2610 0.261 0.58672132 0.58672094 -5.0945935e-07 -0.037695726 -0.037695726 -0.037695726 - 2620 0.262 0.58699873 0.58699843 -4.4497175e-07 -0.037825982 -0.037825982 -0.037825982 - 2630 0.263 0.5872757 0.58727547 -3.7356393e-07 -0.037956089 -0.037956089 -0.037956089 - 2640 0.264 0.58755222 0.58755205 -2.9636401e-07 -0.038086046 -0.038086046 -0.038086046 - 2650 0.265 0.5878283 0.58782817 -2.1459483e-07 -0.038215852 -0.038215852 -0.038215852 - 2660 0.266 0.58810394 0.58810384 -1.2955473e-07 -0.038345508 -0.038345508 -0.038345508 - 2670 0.267 0.58837913 0.58837905 -4.2597042e-08 -0.038475013 -0.038475013 -0.038475013 - 2680 0.268 0.58865388 0.5886538 4.489141e-08 -0.038604367 -0.038604367 -0.038604367 - 2690 0.269 0.5889282 0.58892809 1.315124e-07 -0.038733569 -0.038733569 -0.038733569 - 2700 0.27 0.58920206 0.58920193 2.1587867e-07 -0.038862619 -0.038862619 -0.038862619 - 2710 0.271 0.58947549 0.5894753 2.9663624e-07 -0.038991516 -0.038991516 -0.038991516 - 2720 0.272 0.58974847 0.58974823 3.724862e-07 -0.039120262 -0.039120262 -0.039120262 - 2730 0.273 0.59002101 0.59002069 4.422058e-07 -0.039248854 -0.039248854 -0.039248854 - 2740 0.274 0.59029311 0.5902927 5.0466829e-07 -0.039377293 -0.039377293 -0.039377293 - 2750 0.275 0.59056476 0.59056425 5.5886139e-07 -0.039505578 -0.039505578 -0.039505578 - 2760 0.276 0.59083596 0.59083534 6.0390391e-07 -0.039633709 -0.039633709 -0.039633709 - 2770 0.277 0.59110672 0.59110599 6.3906037e-07 -0.039761687 -0.039761687 -0.039761687 - 2780 0.278 0.59137702 0.59137617 6.6375325e-07 -0.039889509 -0.039889509 -0.039889509 - 2790 0.279 0.59164688 0.59164591 6.7757286e-07 -0.040017177 -0.040017177 -0.040017177 - 2800 0.28 0.59191629 0.5919152 6.8028436e-07 -0.04014469 -0.04014469 -0.04014469 - 2810 0.281 0.59218525 0.59218403 6.7183215e-07 -0.040272047 -0.040272047 -0.040272047 - 2820 0.282 0.59245376 0.59245242 6.5234123e-07 -0.040399248 -0.040399248 -0.040399248 - 2830 0.283 0.59272182 0.59272035 6.221157e-07 -0.040526294 -0.040526294 -0.040526294 - 2840 0.284 0.59298942 0.59298784 5.8163434e-07 -0.040653183 -0.040653183 -0.040653183 - 2850 0.285 0.59325656 0.59325489 5.3154333e-07 -0.040779915 -0.040779915 -0.040779915 - 2860 0.286 0.59352325 0.59352148 4.7264622e-07 -0.040906491 -0.040906491 -0.040906491 - 2870 0.287 0.59378949 0.59378764 4.0589128e-07 -0.041032909 -0.041032909 -0.041032909 - 2880 0.288 0.59405526 0.59405334 3.3235647e-07 -0.04115917 -0.04115917 -0.04115917 - 2890 0.289 0.59432058 0.59431861 2.5323221e-07 -0.041285273 -0.041285273 -0.041285273 - 2900 0.29 0.59458544 0.59458343 1.6980231e-07 -0.041411218 -0.041411218 -0.041411218 - 2910 0.291 0.59484984 0.59484781 8.3423201e-08 -0.041537004 -0.041537004 -0.041537004 - 2920 0.292 0.59511379 0.59511174 -4.4979772e-09 -0.041662632 -0.041662632 -0.041662632 - 2930 0.293 0.59537727 0.59537523 -9.25263e-08 -0.041788101 -0.041788101 -0.041788101 - 2940 0.294 0.5956403 0.59563828 -1.7922246e-07 -0.041913411 -0.041913411 -0.041913411 - 2950 0.295 0.59590287 0.59590089 -2.6316634e-07 -0.042038561 -0.042038561 -0.042038561 - 2960 0.296 0.59616498 0.59616305 -3.4298038e-07 -0.042163552 -0.042163552 -0.042163552 - 2970 0.297 0.59642663 0.59642477 -4.1735227e-07 -0.042288382 -0.042288382 -0.042288382 - 2980 0.298 0.59668783 0.59668604 -4.8505673e-07 -0.042413052 -0.042413052 -0.042413052 - 2990 0.299 0.59694857 0.59694687 -5.4497585e-07 -0.042537562 -0.042537562 -0.042537562 - 3000 0.3 0.59720885 0.59720726 -5.9611782e-07 -0.04266191 -0.04266191 -0.04266191 - 3010 0.301 0.59746868 0.5974672 -6.3763354e-07 -0.042786098 -0.042786098 -0.042786098 - 3020 0.302 0.59772805 0.59772669 -6.6883106e-07 -0.042910124 -0.042910124 -0.042910124 - 3030 0.303 0.59798698 0.59798573 -6.8918737e-07 -0.043033989 -0.043033989 -0.043033989 - 3040 0.304 0.59824545 0.59824433 -6.9835748e-07 -0.043157692 -0.043157692 -0.043157692 - 3050 0.305 0.59850347 0.59850247 -6.9618058e-07 -0.043281233 -0.043281233 -0.043281233 - 3060 0.306 0.59876104 0.59876017 -6.826832e-07 -0.043404611 -0.043404611 -0.043404611 - 3070 0.307 0.59901816 0.59901741 -6.5807923e-07 -0.043527827 -0.043527827 -0.043527827 - 3080 0.308 0.59927483 0.5992742 -6.2276684e-07 -0.04365088 -0.04365088 -0.04365088 - 3090 0.309 0.59953106 0.59953053 -5.7732236e-07 -0.04377377 -0.04377377 -0.04377377 - 3100 0.31 0.59978685 0.59978641 -5.2249119e-07 -0.043896496 -0.043896496 -0.043896496 - 3110 0.311 0.60004219 0.60004184 -4.5917576e-07 -0.044019059 -0.044019059 -0.044019059 - 3120 0.312 0.60029708 0.60029681 -3.8842101e-07 -0.044141458 -0.044141458 -0.044141458 - 3130 0.313 0.60055153 0.60055132 -3.113973e-07 -0.044263693 -0.044263693 -0.044263693 - 3140 0.314 0.60080554 0.60080538 -2.2938121e-07 -0.044385764 -0.044385764 -0.044385764 - 3150 0.315 0.60105911 0.60105898 -1.4373457e-07 -0.04450767 -0.04450767 -0.04450767 - 3160 0.316 0.60131224 0.60131212 -5.5881936e-08 -0.044629411 -0.044629411 -0.044629411 - 3170 0.317 0.60156492 0.60156481 3.2713085e-08 -0.044750988 -0.044750988 -0.044750988 - 3180 0.318 0.60181717 0.60181703 1.2057216e-07 -0.044872399 -0.044872399 -0.044872399 - 3190 0.319 0.60206897 0.6020688 2.0622692e-07 -0.044993645 -0.044993645 -0.044993645 - 3200 0.32 0.60232033 0.60232012 2.882436e-07 -0.045114725 -0.045114725 -0.045114725 - 3210 0.321 0.60257125 0.60257097 3.6524711e-07 -0.045235639 -0.045235639 -0.045235639 - 3220 0.322 0.60282173 0.60282137 4.3594424e-07 -0.045356388 -0.045356388 -0.045356388 - 3230 0.323 0.60307176 0.60307132 4.9914554e-07 -0.045476969 -0.045476969 -0.045476969 - 3240 0.324 0.60332135 0.60332081 5.537856e-07 -0.045597385 -0.045597385 -0.045597385 - 3250 0.325 0.6035705 0.60356985 5.9894116e-07 -0.045717634 -0.045717634 -0.045717634 - 3260 0.326 0.60381921 0.60381844 6.3384706e-07 -0.045837715 -0.045837715 -0.045837715 - 3270 0.327 0.60406746 0.60406658 6.5790942e-07 -0.04595763 -0.04595763 -0.04595763 - 3280 0.328 0.60431528 0.60431427 6.7071607e-07 -0.046077377 -0.046077377 -0.046077377 - 3290 0.329 0.60456264 0.6045615 6.7204395e-07 -0.046196957 -0.046196957 -0.046196957 - 3300 0.33 0.60480956 0.6048083 6.6186325e-07 -0.046316369 -0.046316369 -0.046316369 - 3310 0.331 0.60505602 0.60505464 6.4033837e-07 -0.046435613 -0.046435613 -0.046435613 - 3320 0.332 0.60530204 0.60530054 6.0782561e-07 -0.046554689 -0.046554689 -0.046554689 - 3330 0.333 0.60554761 0.605546 5.6486753e-07 -0.046673597 -0.046673597 -0.046673597 - 3340 0.334 0.60579272 0.60579101 5.1218422e-07 -0.046792336 -0.046792336 -0.046792336 - 3350 0.335 0.60603738 0.60603558 4.5066146e-07 -0.046910906 -0.046910906 -0.046910906 - 3360 0.336 0.60628159 0.60627971 3.8133609e-07 -0.047029308 -0.047029308 -0.047029308 - 3370 0.337 0.60652535 0.6065234 3.0537872e-07 -0.04714754 -0.04714754 -0.04714754 - 3380 0.338 0.60676865 0.60676665 2.2407417e-07 -0.047265604 -0.047265604 -0.047265604 - 3390 0.339 0.6070115 0.60700946 1.3879984e-07 -0.047383497 -0.047383497 -0.047383497 - 3400 0.34 0.60725389 0.60725184 5.1002519e-08 -0.047501222 -0.047501222 -0.047501222 - 3410 0.341 0.60749583 0.60749377 -3.7826124e-08 -0.047618776 -0.047618776 -0.047618776 - 3420 0.342 0.60773732 0.60773527 -1.2617486e-07 -0.04773616 -0.04773616 -0.04773616 - 3430 0.343 0.60797835 0.60797633 -2.1253862e-07 -0.047853375 -0.047853375 -0.047853375 - 3440 0.344 0.60821893 0.60821696 -2.9544421e-07 -0.047970419 -0.047970419 -0.047970419 - 3450 0.345 0.60845905 0.60845714 -3.734755e-07 -0.048087292 -0.048087292 -0.048087292 - 3460 0.346 0.60869873 0.60869689 -4.4529782e-07 -0.048203995 -0.048203995 -0.048203995 - 3470 0.347 0.60893795 0.6089362 -5.0968088e-07 -0.048320527 -0.048320527 -0.048320527 - 3480 0.348 0.60917672 0.60917507 -5.655201e-07 -0.048436888 -0.048436888 -0.048436888 - 3490 0.349 0.60941504 0.60941349 -6.118558e-07 -0.048553078 -0.048553078 -0.048553078 - 3500 0.35 0.60965292 0.60965148 -6.4788989e-07 -0.048669097 -0.048669097 -0.048669097 - 3510 0.351 0.60989034 0.60988903 -6.7299997e-07 -0.048784944 -0.048784944 -0.048784944 - 3520 0.352 0.61012732 0.61012613 -6.8675033e-07 -0.048900619 -0.048900619 -0.048900619 - 3530 0.353 0.61036386 0.6103628 -6.8889983e-07 -0.049016123 -0.049016123 -0.049016123 - 3540 0.354 0.61059995 0.61059901 -6.7940642e-07 -0.049131455 -0.049131455 -0.049131455 - 3550 0.355 0.6108356 0.61083479 -6.5842829e-07 -0.049246615 -0.049246615 -0.049246615 - 3560 0.356 0.61107081 0.61107011 -6.2632151e-07 -0.049361603 -0.049361603 -0.049361603 - 3570 0.357 0.61130559 0.611305 -5.836343e-07 -0.049476418 -0.049476418 -0.049476418 - 3580 0.358 0.61153992 0.61153943 -5.3109794e-07 -0.049591061 -0.049591061 -0.049591061 - 3590 0.359 0.61177381 0.61177342 -4.6961453e-07 -0.049705531 -0.049705531 -0.049705531 - 3600 0.36 0.61200727 0.61200695 -4.0024169e-07 -0.049819829 -0.049819829 -0.049819829 - 3610 0.361 0.6122403 0.61224004 -3.241746e-07 -0.049933953 -0.049933953 -0.049933953 - 3620 0.362 0.61247289 0.61247268 -2.4272558e-07 -0.050047905 -0.050047905 -0.050047905 - 3630 0.363 0.61270504 0.61270487 -1.5730157e-07 -0.050161683 -0.050161683 -0.050161683 - 3640 0.364 0.61293677 0.61293661 -6.937997e-08 -0.050275289 -0.050275289 -0.050275289 - 3650 0.365 0.61316806 0.6131679 1.9516899e-08 -0.05038872 -0.05038872 -0.05038872 - 3660 0.366 0.61339891 0.61339875 1.078481e-07 -0.050501979 -0.050501979 -0.050501979 - 3670 0.367 0.61362934 0.61362914 1.9408082e-07 -0.050615063 -0.050615063 -0.050615063 - 3680 0.368 0.61385933 0.61385909 2.7671704e-07 -0.050727974 -0.050727974 -0.050727974 - 3690 0.369 0.61408889 0.61408858 3.543196e-07 -0.050840711 -0.050840711 -0.050840711 - 3700 0.37 0.61431802 0.61431763 4.2553742e-07 -0.050953274 -0.050953274 -0.050953274 - 3710 0.371 0.61454671 0.61454624 4.891291e-07 -0.051065662 -0.051065662 -0.051065662 - 3720 0.372 0.61477497 0.6147744 5.4398482e-07 -0.051177877 -0.051177877 -0.051177877 - 3730 0.373 0.61500279 0.61500212 5.8914589e-07 -0.051289917 -0.051289917 -0.051289917 - 3740 0.374 0.61523018 0.61522939 6.2382182e-07 -0.051401782 -0.051401782 -0.051401782 - 3750 0.375 0.61545714 0.61545622 6.4740433e-07 -0.051513473 -0.051513473 -0.051513473 - 3760 0.376 0.61568366 0.61568261 6.5947843e-07 -0.05162499 -0.05162499 -0.05162499 - 3770 0.377 0.61590974 0.61590857 6.598299e-07 -0.051736331 -0.051736331 -0.051736331 - 3780 0.378 0.61613538 0.61613409 6.4844946e-07 -0.051847498 -0.051847498 -0.051847498 - 3790 0.379 0.61636058 0.61635917 6.2553327e-07 -0.05195849 -0.05195849 -0.05195849 - 3800 0.38 0.61658534 0.61658381 5.9147985e-07 -0.052069306 -0.052069306 -0.052069306 - 3810 0.381 0.61680966 0.61680803 5.4688338e-07 -0.052179947 -0.052179947 -0.052179947 - 3820 0.382 0.61703355 0.61703181 4.9252369e-07 -0.052290414 -0.052290414 -0.052290414 - 3830 0.383 0.61725699 0.61725516 4.2935278e-07 -0.052400704 -0.052400704 -0.052400704 - 3840 0.384 0.61747998 0.61747808 3.5847842e-07 -0.05251082 -0.05251082 -0.05251082 - 3850 0.385 0.61770254 0.61770057 2.811449e-07 -0.052620759 -0.052620759 -0.052620759 - 3860 0.386 0.61792465 0.61792263 1.9871133e-07 -0.052730523 -0.052730523 -0.052730523 - 3870 0.387 0.61814632 0.61814427 1.126279e-07 -0.052840112 -0.052840112 -0.052840112 - 3880 0.388 0.61836754 0.61836548 2.4410428e-08 -0.052949524 -0.052949524 -0.052949524 - 3890 0.389 0.61858832 0.61858626 -6.4386247e-08 -0.053058761 -0.053058761 -0.053058761 - 3900 0.39 0.61880866 0.61880662 -1.521957e-07 -0.053167821 -0.053167821 -0.053167821 - 3910 0.391 0.61902856 0.61902656 -2.3746757e-07 -0.053276706 -0.053276706 -0.053276706 - 3920 0.392 0.61924802 0.61924606 -3.1869499e-07 -0.053385414 -0.053385414 -0.053385414 - 3930 0.393 0.61946703 0.61946514 -3.9444133e-07 -0.053493947 -0.053493947 -0.053493947 - 3940 0.394 0.61968561 0.6196838 -4.6336578e-07 -0.053602303 -0.053602303 -0.053602303 - 3950 0.395 0.61990374 0.61990202 -5.2424718e-07 -0.053710482 -0.053710482 -0.053710482 - 3960 0.396 0.62012144 0.62011982 -5.7600597e-07 -0.053818486 -0.053818486 -0.053818486 - 3970 0.397 0.62033871 0.6203372 -6.1772348e-07 -0.053926313 -0.053926313 -0.053926313 - 3980 0.398 0.62055553 0.62055414 -6.486585e-07 -0.054033963 -0.054033963 -0.054033963 - 3990 0.399 0.62077193 0.62077066 -6.6826077e-07 -0.054141436 -0.054141436 -0.054141436 - 4000 0.4 0.62098789 0.62098674 -6.7618099e-07 -0.054248733 -0.054248733 -0.054248733 - 4010 0.401 0.62120342 0.6212024 -6.7227739e-07 -0.054355854 -0.054355854 -0.054355854 - 4020 0.402 0.62141852 0.62141762 -6.566185e-07 -0.054462797 -0.054462797 -0.054462797 - 4030 0.403 0.62163319 0.62163242 -6.294823e-07 -0.054569564 -0.054569564 -0.054569564 - 4040 0.404 0.62184744 0.62184677 -5.9135153e-07 -0.054676154 -0.054676154 -0.054676154 - 4050 0.405 0.62206126 0.6220607 -5.4290537e-07 -0.054782567 -0.054782567 -0.054782567 - 4060 0.406 0.62227466 0.62227419 -4.850076e-07 -0.054888803 -0.054888803 -0.054888803 - 4070 0.407 0.62248763 0.62248725 -4.1869146e-07 -0.054994861 -0.054994861 -0.054994861 - 4080 0.408 0.62270018 0.62269987 -3.4514137e-07 -0.055100743 -0.055100743 -0.055100743 - 4090 0.409 0.62291232 0.62291206 -2.6567194e-07 -0.055206448 -0.055206448 -0.055206448 - 4100 0.41 0.62312403 0.62312381 -1.8170469e-07 -0.055311975 -0.055311975 -0.055311975 - 4110 0.411 0.62333532 0.62333513 -9.4742642e-08 -0.055417325 -0.055417325 -0.055417325 - 4120 0.412 0.6235462 0.62354601 -6.3435298e-09 -0.055522499 -0.055522499 -0.055522499 - 4130 0.413 0.62375665 0.62375645 8.1908081e-08 -0.055627494 -0.055627494 -0.055627494 - 4140 0.414 0.62396669 0.62396646 1.6842921e-07 -0.055732313 -0.055732313 -0.055732313 - 4150 0.415 0.62417631 0.62417604 2.5166689e-07 -0.055836954 -0.055836954 -0.055836954 - 4160 0.416 0.62438551 0.62438518 3.3012615e-07 -0.055941417 -0.055941417 -0.055941417 - 4170 0.417 0.6245943 0.6245939 4.0239694e-07 -0.056045704 -0.056045704 -0.056045704 - 4180 0.418 0.62480266 0.62480218 4.6717967e-07 -0.056149812 -0.056149812 -0.056149812 - 4190 0.419 0.62501061 0.62501003 5.2330875e-07 -0.056253744 -0.056253744 -0.056253744 - 4200 0.42 0.62521814 0.62521745 5.6977374e-07 -0.056357498 -0.056357498 -0.056357498 - 4210 0.421 0.62542525 0.62542444 6.057378e-07 -0.056461074 -0.056461074 -0.056461074 - 4220 0.422 0.62563194 0.62563101 6.3055304e-07 -0.056564473 -0.056564473 -0.056564473 - 4230 0.423 0.6258382 0.62583716 6.4377238e-07 -0.056667694 -0.056667694 -0.056667694 - 4240 0.424 0.62604405 0.62604288 6.4515798e-07 -0.056770738 -0.056770738 -0.056770738 - 4250 0.425 0.62624947 0.62624817 6.3468571e-07 -0.056873604 -0.056873604 -0.056873604 - 4260 0.426 0.62645447 0.62645305 6.1254589e-07 -0.056976292 -0.056976292 -0.056976292 - 4270 0.427 0.62665905 0.62665751 5.7914013e-07 -0.057078803 -0.057078803 -0.057078803 - 4280 0.428 0.6268632 0.62686155 5.3507424e-07 -0.057181136 -0.057181136 -0.057181136 - 4290 0.429 0.62706692 0.62706518 4.8114756e-07 -0.057283292 -0.057283292 -0.057283292 - 4300 0.43 0.62727022 0.62726839 4.1833866e-07 -0.057385269 -0.057385269 -0.057385269 - 4310 0.431 0.6274731 0.62747119 3.4778776e-07 -0.05748707 -0.05748707 -0.05748707 - 4320 0.432 0.62767554 0.62767358 2.7077627e-07 -0.057588692 -0.057588692 -0.057588692 - 4330 0.433 0.62787756 0.62787555 1.8870359e-07 -0.057690137 -0.057690137 -0.057690137 - 4340 0.434 0.62807916 0.62807712 1.0306185e-07 -0.057791404 -0.057791404 -0.057791404 - 4350 0.435 0.62828033 0.62827827 1.5408826e-08 -0.057892494 -0.057892494 -0.057892494 - 4360 0.436 0.62848107 0.62847902 -7.2660336e-08 -0.057993406 -0.057993406 -0.057993406 - 4370 0.437 0.62868138 0.62867935 -1.5954216e-07 -0.05809414 -0.05809414 -0.05809414 - 4380 0.438 0.62888127 0.62887928 -2.4365405e-07 -0.058194696 -0.058194696 -0.058194696 - 4390 0.439 0.62908074 0.6290788 -3.2346322e-07 -0.058295075 -0.058295075 -0.058295075 - 4400 0.44 0.62927978 0.62927791 -3.9751471e-07 -0.058395277 -0.058395277 -0.058395277 - 4410 0.441 0.6294784 0.62947661 -4.6445802e-07 -0.0584953 -0.0584953 -0.0584953 - 4420 0.442 0.6296766 0.6296749 -5.2307198e-07 -0.058595146 -0.058595146 -0.058595146 - 4430 0.443 0.62987438 0.62987278 -5.7228716e-07 -0.058694815 -0.058694815 -0.058694815 - 4440 0.444 0.63007174 0.63007025 -6.1120565e-07 -0.058794305 -0.058794305 -0.058794305 - 4450 0.445 0.63026869 0.63026731 -6.3911762e-07 -0.058893618 -0.058893618 -0.058893618 - 4460 0.446 0.63046521 0.63046396 -6.5551459e-07 -0.058992754 -0.058992754 -0.058992754 - 4470 0.447 0.63066133 0.6306602 -6.6009891e-07 -0.059091712 -0.059091712 -0.059091712 - 4480 0.448 0.63085703 0.63085602 -6.5278946e-07 -0.059190493 -0.059190493 -0.059190493 - 4490 0.449 0.63105232 0.63105143 -6.3372335e-07 -0.059289096 -0.059289096 -0.059289096 - 4500 0.45 0.6312472 0.63124643 -6.032536e-07 -0.059387521 -0.059387521 -0.059387521 - 4510 0.451 0.63144167 0.63144101 -5.6194288e-07 -0.05948577 -0.05948577 -0.05948577 - 4520 0.452 0.63163573 0.63163518 -5.1055337e-07 -0.05958384 -0.05958384 -0.05958384 - 4530 0.453 0.6318294 0.63182893 -4.500329e-07 -0.059681734 -0.059681734 -0.059681734 - 4540 0.454 0.63202265 0.63202226 -3.8149769e-07 -0.05977945 -0.05977945 -0.05977945 - 4550 0.455 0.63221551 0.63221518 -3.0621194e-07 -0.059876988 -0.059876988 -0.059876988 - 4560 0.456 0.63240796 0.63240768 -2.2556465e-07 -0.05997435 -0.05997435 -0.05997435 - 4570 0.457 0.63260001 0.63259976 -1.4104413e-07 -0.060071534 -0.060071534 -0.060071534 - 4580 0.458 0.63279166 0.63279143 -5.4210581e-08 -0.06016854 -0.06016854 -0.06016854 - 4590 0.459 0.63298291 0.63298268 3.3332623e-08 -0.06026537 -0.06026537 -0.06026537 - 4600 0.46 0.63317376 0.63317351 1.1996854e-07 -0.060362023 -0.060362023 -0.060362023 - 4610 0.461 0.63336422 0.63336393 2.0409657e-07 -0.060458498 -0.060458498 -0.060458498 - 4620 0.462 0.63355427 0.63355394 2.8416203e-07 -0.060554796 -0.060554796 -0.060554796 - 4630 0.463 0.63374393 0.63374353 3.5868507e-07 -0.060650918 -0.060650918 -0.060650918 - 4640 0.464 0.63393318 0.6339327 4.2628804e-07 -0.060746862 -0.060746862 -0.060746862 - 4650 0.465 0.63412204 0.63412147 4.8572121e-07 -0.060842629 -0.060842629 -0.060842629 - 4660 0.466 0.6343105 0.63430983 5.35886e-07 -0.06093822 -0.06093822 -0.06093822 - 4670 0.467 0.63449856 0.63449778 5.7585552e-07 -0.061033634 -0.061033634 -0.061033634 - 4680 0.468 0.63468622 0.63468532 6.048919e-07 -0.06112887 -0.06112887 -0.06112887 - 4690 0.469 0.63487347 0.63487245 6.2246016e-07 -0.061223931 -0.061223931 -0.061223931 - 4700 0.47 0.63506033 0.63505918 6.2823833e-07 -0.061318814 -0.061318814 -0.061318814 - 4710 0.471 0.63524678 0.63524551 6.2212359e-07 -0.061413521 -0.061413521 -0.061413521 - 4720 0.472 0.63543283 0.63543144 6.0423435e-07 -0.061508051 -0.061508051 -0.061508051 - 4730 0.473 0.63561847 0.63561697 5.7490826e-07 -0.061602405 -0.061602405 -0.061602405 - 4740 0.474 0.63580371 0.6358021 5.3469601e-07 -0.061696582 -0.061696582 -0.061696582 - 4750 0.475 0.63598855 0.63598684 4.8435128e-07 -0.061790583 -0.061790583 -0.061790583 - 4760 0.476 0.63617298 0.63617118 4.2481683e-07 -0.061884408 -0.061884408 -0.061884408 - 4770 0.477 0.63635701 0.63635512 3.5720699e-07 -0.061978056 -0.061978056 -0.061978056 - 4780 0.478 0.63654062 0.63653868 2.8278703e-07 -0.062071529 -0.062071529 -0.062071529 - 4790 0.479 0.63672384 0.63672184 2.0294959e-07 -0.062164825 -0.062164825 -0.062164825 - 4800 0.48 0.63690664 0.63690461 1.1918874e-07 -0.062257945 -0.062257945 -0.062257945 - 4810 0.481 0.63708904 0.637087 3.3072095e-08 -0.062350889 -0.062350889 -0.062350889 - 4820 0.482 0.63727104 0.63726899 -5.3788471e-08 -0.062443657 -0.062443657 -0.062443657 - 4830 0.483 0.63745263 0.6374506 -1.39767e-07 -0.062536249 -0.062536249 -0.062536249 - 4840 0.484 0.63763381 0.63763182 -2.2325389e-07 -0.062628665 -0.062628665 -0.062628665 - 4850 0.485 0.63781459 0.63781265 -3.0268612e-07 -0.062720906 -0.062720906 -0.062720906 - 4860 0.486 0.63799497 0.63799309 -3.7657657e-07 -0.062812971 -0.062812971 -0.062812971 - 4870 0.487 0.63817495 0.63817314 -4.4354199e-07 -0.062904861 -0.062904861 -0.062904861 - 4880 0.488 0.63835452 0.63835281 -5.0232909e-07 -0.062996575 -0.062996575 -0.062996575 - 4890 0.489 0.6385337 0.63853208 -5.5183811e-07 -0.063088114 -0.063088114 -0.063088114 - 4900 0.49 0.63871248 0.63871097 -5.9114363e-07 -0.063179477 -0.063179477 -0.063179477 - 4910 0.491 0.63889086 0.63888947 -6.1951209e-07 -0.063270665 -0.063270665 -0.063270665 - 4920 0.492 0.63906885 0.63906758 -6.3641568e-07 -0.063361678 -0.063361678 -0.063361678 - 4930 0.493 0.63924644 0.6392453 -6.4154246e-07 -0.063452516 -0.063452516 -0.063452516 - 4940 0.494 0.63942365 0.63942262 -6.3480228e-07 -0.063543179 -0.063543179 -0.063543179 - 4950 0.495 0.63960046 0.63959956 -6.1632869e-07 -0.063633667 -0.063633667 -0.063633667 - 4960 0.496 0.63977689 0.6397761 -5.8647648e-07 -0.063723981 -0.063723981 -0.063723981 - 4970 0.497 0.63995293 0.63995224 -5.4581515e-07 -0.063814119 -0.063814119 -0.063814119 - 4980 0.498 0.64012859 0.640128 -4.9511825e-07 -0.063904083 -0.063904083 -0.063904083 - 4990 0.499 0.64030386 0.64030336 -4.3534885e-07 -0.063993873 -0.063993873 -0.063993873 - 5000 0.5 0.64047875 0.64047832 -3.6764149e-07 -0.064083488 -0.064083488 -0.064083488 - 5010 0.501 0.64065325 0.64065289 -2.9328075e-07 -0.064172929 -0.064172929 -0.064172929 - 5020 0.502 0.64082738 0.64082707 -2.1367704e-07 -0.064262195 -0.064262195 -0.064262195 - 5030 0.503 0.64100113 0.64100085 -1.3033993e-07 -0.064351288 -0.064351288 -0.064351288 - 5040 0.504 0.6411745 0.64117423 -4.4849648e-08 -0.064440206 -0.064440206 -0.064440206 - 5050 0.505 0.6413475 0.64134722 4.1172909e-08 -0.06452895 -0.06452895 -0.06452895 - 5060 0.506 0.64152011 0.64151982 1.2609686e-07 -0.064617521 -0.064617521 -0.064617521 - 5070 0.507 0.64169236 0.64169202 2.0831228e-07 -0.064705918 -0.064705918 -0.064705918 - 5080 0.508 0.64186422 0.64186384 2.8626081e-07 -0.064794141 -0.064794141 -0.064794141 - 5090 0.509 0.64203571 0.64203526 3.5846527e-07 -0.064882191 -0.064882191 -0.064882191 - 5100 0.51 0.64220682 0.64220629 4.2355775e-07 -0.064970067 -0.064970067 -0.064970067 - 5110 0.511 0.64237755 0.64237693 4.8030571e-07 -0.06505777 -0.06505777 -0.06505777 - 5120 0.512 0.64254791 0.64254719 5.2763546e-07 -0.0651453 -0.0651453 -0.0651453 - 5130 0.513 0.64271789 0.64271705 5.6465267e-07 -0.065232657 -0.065232657 -0.065232657 - 5140 0.514 0.64288749 0.64288654 5.906595e-07 -0.06531984 -0.06531984 -0.06531984 - 5150 0.515 0.64305671 0.64305564 6.0516793e-07 -0.065406851 -0.065406851 -0.065406851 - 5160 0.516 0.64322555 0.64322436 6.0790921e-07 -0.065493689 -0.065493689 -0.065493689 - 5170 0.517 0.64339401 0.6433927 5.9883899e-07 -0.065580355 -0.065580355 -0.065580355 - 5180 0.518 0.64356209 0.64356067 5.7813833e-07 -0.065666848 -0.065666848 -0.065666848 - 5190 0.519 0.64372979 0.64372826 5.4621027e-07 -0.065753168 -0.065753168 -0.065753168 - 5200 0.52 0.64389711 0.64389547 5.036722e-07 -0.065839316 -0.065839316 -0.065839316 - 5210 0.521 0.64406405 0.64406231 4.5134419e-07 -0.065925292 -0.065925292 -0.065925292 - 5220 0.522 0.6442306 0.64422878 3.9023331e-07 -0.066011096 -0.066011096 -0.066011096 - 5230 0.523 0.64439677 0.64439488 3.2151444e-07 -0.066096729 -0.066096729 -0.066096729 - 5240 0.524 0.64456256 0.64456061 2.4650783e-07 -0.066182189 -0.066182189 -0.066182189 - 5250 0.525 0.64472797 0.64472597 1.6665388e-07 -0.066267477 -0.066267477 -0.066267477 - 5260 0.526 0.64489299 0.64489096 8.3485522e-08 -0.066352594 -0.066352594 -0.066352594 - 5270 0.527 0.64505763 0.64505559 -1.4011251e-09 -0.06643754 -0.06643754 -0.06643754 - 5280 0.528 0.64522188 0.64521986 -8.6377351e-08 -0.066522314 -0.066522314 -0.066522314 - 5290 0.529 0.64538576 0.64538376 -1.6981312e-07 -0.066606917 -0.066606917 -0.066606917 - 5300 0.53 0.64554925 0.64554729 -2.5010835e-07 -0.066691349 -0.066691349 -0.066691349 - 5310 0.531 0.64571237 0.64571046 -3.2572373e-07 -0.066775611 -0.066775611 -0.066775611 - 5320 0.532 0.6458751 0.64587326 -3.9521022e-07 -0.066859701 -0.066859701 -0.066859701 - 5330 0.533 0.64603746 0.6460357 -4.5723704e-07 -0.066943621 -0.066943621 -0.066943621 - 5340 0.534 0.64619944 0.64619778 -5.1061726e-07 -0.06702737 -0.06702737 -0.06702737 - 5350 0.535 0.64636105 0.64635948 -5.5433068e-07 -0.067110948 -0.067110948 -0.067110948 - 5360 0.536 0.64652228 0.64652083 -5.8754354e-07 -0.067194357 -0.067194357 -0.067194357 - 5370 0.537 0.64668314 0.6466818 -6.0962458e-07 -0.067277595 -0.067277595 -0.067277595 - 5380 0.538 0.64684363 0.64684241 -6.2015733e-07 -0.067360664 -0.067360664 -0.067360664 - 5390 0.539 0.64700376 0.64700266 -6.1894809e-07 -0.067443562 -0.067443562 -0.067443562 - 5400 0.54 0.64716351 0.64716253 -6.0602979e-07 -0.067526291 -0.067526291 -0.067526291 - 5410 0.541 0.6473229 0.64732204 -5.8166135e-07 -0.06760885 -0.06760885 -0.06760885 - 5420 0.542 0.64748193 0.64748117 -5.4632271e-07 -0.06769124 -0.06769124 -0.06769124 - 5430 0.543 0.6476406 0.64763994 -5.0070563e-07 -0.06777346 -0.06777346 -0.06777346 - 5440 0.544 0.6477989 0.64779833 -4.4570029e-07 -0.067855512 -0.067855512 -0.067855512 - 5450 0.545 0.64795685 0.64795636 -3.8237815e-07 -0.067937394 -0.067937394 -0.067937394 - 5460 0.546 0.64811444 0.64811401 -3.119712e-07 -0.068019108 -0.068019108 -0.068019108 - 5470 0.547 0.64827167 0.6482713 -2.3584813e-07 -0.068100653 -0.068100653 -0.068100653 - 5480 0.548 0.64842855 0.64842821 -1.5548783e-07 -0.068182029 -0.068182029 -0.068182029 - 5490 0.549 0.64858507 0.64858475 -7.2450737e-08 -0.068263237 -0.068263237 -0.068263237 - 5500 0.55 0.64874124 0.64874092 1.1651408e-08 -0.068344276 -0.068344276 -0.068344276 - 5510 0.551 0.64889706 0.64889673 9.5186848e-08 -0.068425148 -0.068425148 -0.068425148 - 5520 0.552 0.64905252 0.64905216 1.7653547e-07 -0.068505851 -0.068505851 -0.068505851 - 5530 0.553 0.64920763 0.64920722 2.5412026e-07 -0.068586387 -0.068586387 -0.068586387 - 5540 0.554 0.64936239 0.64936192 3.2643798e-07 -0.068666755 -0.068666755 -0.068666755 - 5550 0.555 0.64951679 0.64951625 3.9208836e-07 -0.068746955 -0.068746955 -0.068746955 - 5560 0.556 0.64967085 0.64967022 4.4980134e-07 -0.068826988 -0.068826988 -0.068826988 - 5570 0.557 0.64982455 0.64982382 4.984618e-07 -0.068906854 -0.068906854 -0.068906854 - 5580 0.558 0.64997789 0.64997706 5.3713127e-07 -0.068986553 -0.068986553 -0.068986553 - 5590 0.559 0.65013089 0.65012995 5.6506622e-07 -0.069066085 -0.069066085 -0.069066085 - 5600 0.56 0.65028353 0.65028247 5.8173253e-07 -0.069145451 -0.069145451 -0.069145451 - 5610 0.561 0.65043581 0.65043463 5.8681591e-07 -0.069224649 -0.069224649 -0.069224649 - 5620 0.562 0.65058774 0.65058645 5.8022805e-07 -0.069303682 -0.069303682 -0.069303682 - 5630 0.563 0.65073931 0.6507379 5.6210832e-07 -0.069382548 -0.069382548 -0.069382548 - 5640 0.564 0.65089053 0.65088901 5.3282107e-07 -0.069461248 -0.069461248 -0.069461248 - 5650 0.565 0.65104139 0.65103976 4.9294848e-07 -0.069539782 -0.069539782 -0.069539782 - 5660 0.566 0.65119189 0.65119017 4.4327921e-07 -0.06961815 -0.06961815 -0.06961815 - 5670 0.567 0.65134203 0.65134023 3.8479296e-07 -0.069696352 -0.069696352 -0.069696352 - 5680 0.568 0.65149182 0.65148994 3.186413e-07 -0.06977439 -0.06977439 -0.06977439 - 5690 0.569 0.65164124 0.65163931 2.4612515e-07 -0.069852262 -0.069852262 -0.069852262 - 5700 0.57 0.65179031 0.65178833 1.6866929e-07 -0.069929968 -0.069929968 -0.069929968 - 5710 0.571 0.65193902 0.65193702 8.7794446e-08 -0.07000751 -0.07000751 -0.07000751 - 5720 0.572 0.65208737 0.65208536 5.0875238e-09 -0.070084887 -0.070084887 -0.070084887 - 5730 0.573 0.65223537 0.65223336 -7.7829543e-08 -0.0701621 -0.0701621 -0.0701621 - 5740 0.574 0.65238301 0.65238102 -1.5933158e-07 -0.070239148 -0.070239148 -0.070239148 - 5750 0.575 0.65253029 0.65252834 -2.3782204e-07 -0.070316032 -0.070316032 -0.070316032 - 5760 0.576 0.65267721 0.65267532 -3.1176438e-07 -0.070392751 -0.070392751 -0.070392751 - 5770 0.577 0.65282379 0.65282196 -3.7971217e-07 -0.070469307 -0.070469307 -0.070469307 - 5780 0.578 0.65297001 0.65296826 -4.4033753e-07 -0.070545699 -0.070545699 -0.070545699 - 5790 0.579 0.65311588 0.65311422 -4.9245722e-07 -0.070621928 -0.070621928 -0.070621928 - 5800 0.58 0.65326139 0.65325983 -5.3505586e-07 -0.070697993 -0.070697993 -0.070697993 - 5810 0.581 0.65340657 0.65340511 -5.6730589e-07 -0.070773895 -0.070773895 -0.070773895 - 5820 0.582 0.65355139 0.65355005 -5.8858382e-07 -0.070849633 -0.070849633 -0.070849633 - 5830 0.583 0.65369587 0.65369464 -5.9848249e-07 -0.070925209 -0.070925209 -0.070925209 - 5840 0.584 0.65384 0.65383889 -5.9681904e-07 -0.071000623 -0.071000623 -0.071000623 - 5850 0.585 0.6539838 0.6539828 -5.8363849e-07 -0.071075873 -0.071075873 -0.071075873 - 5860 0.586 0.65412725 0.65412637 -5.5921279e-07 -0.071150962 -0.071150962 -0.071150962 - 5870 0.587 0.65427036 0.65426959 -5.2403544e-07 -0.071225888 -0.071225888 -0.071225888 - 5880 0.588 0.65441314 0.65441246 -4.7881168e-07 -0.071300652 -0.071300652 -0.071300652 - 5890 0.589 0.65455559 0.65455499 -4.2444456e-07 -0.071375254 -0.071375254 -0.071375254 - 5900 0.59 0.6546977 0.65469718 -3.6201704e-07 -0.071449695 -0.071449695 -0.071449695 - 5910 0.591 0.65483947 0.65483902 -2.9277058e-07 -0.071523975 -0.071523975 -0.071523975 - 5920 0.592 0.65498092 0.65498051 -2.1808055e-07 -0.071598093 -0.071598093 -0.071598093 - 5930 0.593 0.65512204 0.65512166 -1.39429e-07 -0.07167205 -0.07167205 -0.07167205 - 5940 0.594 0.65526282 0.65526246 -5.837535e-08 -0.071745846 -0.071745846 -0.071745846 - 5950 0.595 0.65540328 0.65540292 2.3474531e-08 -0.071819481 -0.071819481 -0.071819481 - 5960 0.596 0.65554341 0.65554303 1.045001e-07 -0.071892956 -0.071892956 -0.071892956 - 5970 0.597 0.65568321 0.6556828 1.8309825e-07 -0.071966271 -0.071966271 -0.071966271 - 5980 0.598 0.65582269 0.65582223 2.5771506e-07 -0.072039425 -0.072039425 -0.072039425 - 5990 0.599 0.65596183 0.65596132 3.2687663e-07 -0.07211242 -0.07211242 -0.07211242 - 6000 0.6 0.65610065 0.65610006 3.8921821e-07 -0.072185255 -0.072185255 -0.072185255 - 6010 0.601 0.65623915 0.65623847 4.4351131e-07 -0.07225793 -0.07225793 -0.07225793 - 6020 0.602 0.65637731 0.65637654 4.8868803e-07 -0.072330445 -0.072330445 -0.072330445 - 6030 0.603 0.65651515 0.65651427 5.2386219e-07 -0.072402802 -0.072402802 -0.072402802 - 6040 0.604 0.65665265 0.65665167 5.483469e-07 -0.072475 -0.072475 -0.072475 - 6050 0.605 0.65678983 0.65678873 5.6166814e-07 -0.072547038 -0.072547038 -0.072547038 - 6060 0.606 0.65692668 0.65692546 5.6357412e-07 -0.072618918 -0.072618918 -0.072618918 - 6070 0.607 0.6570632 0.65706187 5.5404021e-07 -0.07269064 -0.07269064 -0.07269064 - 6080 0.608 0.65719939 0.65719794 5.3326936e-07 -0.072762203 -0.072762203 -0.072762203 - 6090 0.609 0.65733524 0.65733369 5.0168797e-07 -0.072833609 -0.072833609 -0.072833609 - 6100 0.61 0.65747077 0.65746912 4.5993733e-07 -0.072904856 -0.072904856 -0.072904856 - 6110 0.611 0.65760596 0.65760422 4.0886077e-07 -0.072975946 -0.072975946 -0.072975946 - 6120 0.612 0.65774082 0.65773901 3.4948676e-07 -0.073046879 -0.073046879 -0.073046879 - 6130 0.613 0.65787535 0.65787347 2.8300837e-07 -0.073117654 -0.073117654 -0.073117654 - 6140 0.614 0.65800954 0.65800761 2.1075937e-07 -0.073188272 -0.073188272 -0.073188272 - 6150 0.615 0.6581434 0.65814143 1.341876e-07 -0.073258733 -0.073258733 -0.073258733 - 6160 0.616 0.65827693 0.65827494 5.482599e-08 -0.073329038 -0.073329038 -0.073329038 - 6170 0.617 0.65841013 0.65840813 -2.5738053e-08 -0.073399186 -0.073399186 -0.073399186 - 6180 0.618 0.65854299 0.65854101 -1.0589441e-07 -0.073469178 -0.073469178 -0.073469178 - 6190 0.619 0.65867553 0.65867357 -1.8404242e-07 -0.073539013 -0.073539013 -0.073539013 - 6200 0.62 0.65880773 0.65880582 -2.586229e-07 -0.073608693 -0.073608693 -0.073608693 - 6210 0.621 0.6589396 0.65893775 -3.2814928e-07 -0.073678217 -0.073678217 -0.073678217 - 6220 0.622 0.65907115 0.65906937 -3.9123734e-07 -0.073747586 -0.073747586 -0.073747586 - 6230 0.623 0.65920237 0.65920067 -4.4663288e-07 -0.073816799 -0.073816799 -0.073816799 - 6240 0.624 0.65933327 0.65933165 -4.9323677e-07 -0.073885858 -0.073885858 -0.073885858 - 6250 0.625 0.65946384 0.65946233 -5.3012687e-07 -0.073954761 -0.073954761 -0.073954761 - 6260 0.626 0.65959409 0.65959268 -5.565765e-07 -0.07402351 -0.07402351 -0.07402351 - 6270 0.627 0.65972402 0.65972272 -5.7206883e-07 -0.074092104 -0.074092104 -0.074092104 - 6280 0.628 0.65985363 0.65985244 -5.7630721e-07 -0.074160545 -0.074160545 -0.074160545 - 6290 0.629 0.65998292 0.65998185 -5.6922099e-07 -0.074228831 -0.074228831 -0.074228831 - 6300 0.63 0.6601119 0.66011094 -5.5096683e-07 -0.074296963 -0.074296963 -0.074296963 - 6310 0.631 0.66024056 0.66023971 -5.2192546e-07 -0.074364941 -0.074364941 -0.074364941 - 6320 0.632 0.66036891 0.66036816 -4.8269389e-07 -0.074432767 -0.074432767 -0.074432767 - 6330 0.633 0.66049695 0.66049629 -4.340733e-07 -0.074500438 -0.074500438 -0.074500438 - 6340 0.634 0.66062468 0.6606241 -3.7705289e-07 -0.074567957 -0.074567957 -0.074567957 - 6350 0.635 0.66075211 0.66075159 -3.1278979e-07 -0.074635324 -0.074635324 -0.074635324 - 6360 0.636 0.66087923 0.66087876 -2.4258579e-07 -0.074702537 -0.074702537 -0.074702537 - 6370 0.637 0.66100604 0.66100561 -1.6786098e-07 -0.074769598 -0.074769598 -0.074769598 - 6380 0.638 0.66113255 0.66113214 -9.0125159e-08 -0.074836507 -0.074836507 -0.074836507 - 6390 0.639 0.66125875 0.66125835 -1.0947326e-08 -0.074903264 -0.074903264 -0.074903264 - 6400 0.64 0.66138466 0.66138424 6.8075937e-08 -0.074969869 -0.074969869 -0.074969869 - 6410 0.641 0.66151025 0.66150982 1.4535267e-07 -0.075036323 -0.075036323 -0.075036323 - 6420 0.642 0.66163555 0.66163508 2.1932764e-07 -0.075102625 -0.075102625 -0.075102625 - 6430 0.643 0.66176055 0.66176002 2.8851367e-07 -0.075168776 -0.075168776 -0.075168776 - 6440 0.644 0.66188524 0.66188464 3.5152165e-07 -0.075234776 -0.075234776 -0.075234776 - 6450 0.645 0.66200963 0.66200895 4.0708847e-07 -0.075300626 -0.075300626 -0.075300626 - 6460 0.646 0.66213372 0.66213295 4.5410251e-07 -0.075366325 -0.075366325 -0.075366325 - 6470 0.647 0.66225751 0.66225664 4.9162594e-07 -0.075431874 -0.075431874 -0.075431874 - 6480 0.648 0.66238099 0.66238002 5.1891364e-07 -0.075497273 -0.075497273 -0.075497273 - 6490 0.649 0.66250417 0.66250309 5.3542807e-07 -0.075562521 -0.075562521 -0.075562521 - 6500 0.65 0.66262704 0.66262585 5.4085008e-07 -0.075627621 -0.075627621 -0.075627621 - 6510 0.651 0.66274961 0.66274831 5.3508518e-07 -0.07569257 -0.07569257 -0.07569257 - 6520 0.652 0.66287188 0.66287047 5.1826535e-07 -0.075757371 -0.075757371 -0.075757371 - 6530 0.653 0.66299384 0.66299232 4.9074618e-07 -0.075822022 -0.075822022 -0.075822022 - 6540 0.654 0.66311549 0.66311388 4.5309958e-07 -0.075886525 -0.075886525 -0.075886525 - 6550 0.655 0.66323684 0.66323514 4.0610197e-07 -0.075950879 -0.075950879 -0.075950879 - 6560 0.656 0.66335788 0.6633561 3.5071851e-07 -0.076015085 -0.076015085 -0.076015085 - 6570 0.657 0.66347861 0.66347677 2.8808331e-07 -0.076079143 -0.076079143 -0.076079143 - 6580 0.658 0.66359904 0.66359714 2.1947637e-07 -0.076143053 -0.076143053 -0.076143053 - 6590 0.659 0.66371916 0.66371722 1.462975e-07 -0.076206815 -0.076206815 -0.076206815 - 6600 0.66 0.66383897 0.66383701 7.003782e-08 -0.07627043 -0.07627043 -0.07627043 - 6610 0.661 0.66395847 0.6639565 -7.7505971e-09 -0.076333897 -0.076333897 -0.076333897 - 6620 0.662 0.66407767 0.66407571 -8.5486262e-08 -0.076397218 -0.076397218 -0.076397218 - 6630 0.663 0.66419657 0.66419463 -1.6159044e-07 -0.076460391 -0.076460391 -0.076460391 - 6640 0.664 0.66431515 0.66431325 -2.3451925e-07 -0.076523418 -0.076523418 -0.076523418 - 6650 0.665 0.66443344 0.66443159 -3.02795e-07 -0.076586299 -0.076586299 -0.076586299 - 6660 0.666 0.66455142 0.66454964 -3.6503624e-07 -0.076649033 -0.076649033 -0.076649033 - 6670 0.667 0.6646691 0.66466739 -4.1998576e-07 -0.076711622 -0.076711622 -0.076711622 - 6680 0.668 0.66478648 0.66478486 -4.6653612e-07 -0.076774064 -0.076774064 -0.076774064 - 6690 0.669 0.66490357 0.66490204 -5.0375208e-07 -0.076836362 -0.076836362 -0.076836362 - 6700 0.67 0.66502035 0.66501893 -5.308895e-07 -0.076898514 -0.076898514 -0.076898514 - 6710 0.671 0.66513684 0.66513553 -5.4741039e-07 -0.07696052 -0.07696052 -0.07696052 - 6720 0.672 0.66525304 0.66525183 -5.5299372e-07 -0.077022383 -0.077022383 -0.077022383 - 6730 0.673 0.66536894 0.66536785 -5.4754176e-07 -0.0770841 -0.0770841 -0.0770841 - 6740 0.674 0.66548456 0.66548357 -5.3118195e-07 -0.077145673 -0.077145673 -0.077145673 - 6750 0.675 0.66559988 0.66559899 -5.042641e-07 -0.077207102 -0.077207102 -0.077207102 - 6760 0.676 0.66571492 0.66571413 -4.6735306e-07 -0.077268387 -0.077268387 -0.077268387 - 6770 0.677 0.66582968 0.66582897 -4.2121706e-07 -0.077329528 -0.077329528 -0.077329528 - 6780 0.678 0.66594414 0.66594352 -3.6681181e-07 -0.077390526 -0.077390526 -0.077390526 - 6790 0.679 0.66605833 0.66605777 -3.0526088e-07 -0.077451381 -0.077451381 -0.077451381 - 6800 0.68 0.66617224 0.66617172 -2.3783252e-07 -0.077512092 -0.077512092 -0.077512092 - 6810 0.681 0.66628586 0.66628539 -1.6591369e-07 -0.077572661 -0.077572661 -0.077572661 - 6820 0.682 0.66639921 0.66639875 -9.0981551e-08 -0.077633087 -0.077633087 -0.077633087 - 6830 0.683 0.66651227 0.66651183 -1.4573167e-08 -0.07769337 -0.07769337 -0.07769337 - 6840 0.684 0.66662506 0.66662461 6.1745978e-08 -0.077753512 -0.077753512 -0.077753512 - 6850 0.685 0.66673757 0.6667371 1.3641408e-07 -0.077813512 -0.077813512 -0.077813512 - 6860 0.686 0.66684981 0.66684929 2.0790497e-07 -0.07787337 -0.07787337 -0.07787337 - 6870 0.687 0.66696177 0.6669612 2.747594e-07 -0.077933086 -0.077933086 -0.077933086 - 6880 0.688 0.66707345 0.66707281 3.3561482e-07 -0.077992661 -0.077992661 -0.077992661 - 6890 0.689 0.66718485 0.66718414 3.8923331e-07 -0.078052095 -0.078052095 -0.078052095 - 6900 0.69 0.66729597 0.66729518 4.3452679e-07 -0.078111389 -0.078111389 -0.078111389 - 6910 0.691 0.66740682 0.66740593 4.7057924e-07 -0.078170542 -0.078170542 -0.078170542 - 6920 0.692 0.66751739 0.6675164 4.9666535e-07 -0.078229554 -0.078229554 -0.078229554 - 6930 0.693 0.66762768 0.66762659 5.1226525e-07 -0.078288426 -0.078288426 -0.078288426 - 6940 0.694 0.6677377 0.66773649 5.1707495e-07 -0.078347159 -0.078347159 -0.078347159 - 6950 0.695 0.66784743 0.66784612 5.1101247e-07 -0.078405752 -0.078405752 -0.078405752 - 6960 0.696 0.66795688 0.66795547 4.9421925e-07 -0.078464205 -0.078464205 -0.078464205 - 6970 0.697 0.66806605 0.66806454 4.670571e-07 -0.078522519 -0.078522519 -0.078522519 - 6980 0.698 0.66817494 0.66817333 4.301005e-07 -0.078580695 -0.078580695 -0.078580695 - 6990 0.699 0.66828355 0.66828186 3.8412465e-07 -0.078638731 -0.078638731 -0.078638731 - 7000 0.7 0.66839188 0.66839011 3.3008929e-07 -0.078696629 -0.078696629 -0.078696629 - 7010 0.701 0.66849993 0.66849809 2.6911881e-07 -0.078754389 -0.078754389 -0.078754389 - 7020 0.702 0.66860769 0.66860581 2.0247889e-07 -0.078812011 -0.078812011 -0.078812011 - 7030 0.703 0.66871517 0.66871325 1.3155039e-07 -0.078869494 -0.078869494 -0.078869494 - 7040 0.704 0.66882237 0.66882043 5.7800711e-08 -0.078926841 -0.078926841 -0.078926841 - 7050 0.705 0.66892929 0.66892734 -1.724648e-08 -0.07898405 -0.07898405 -0.07898405 - 7060 0.706 0.66903593 0.66903399 -9.2042729e-08 -0.079041121 -0.079041121 -0.079041121 - 7070 0.707 0.66914228 0.66914037 -1.6504674e-07 -0.079098056 -0.079098056 -0.079098056 - 7080 0.708 0.66924836 0.66924649 -2.3475617e-07 -0.079154854 -0.079154854 -0.079154854 - 7090 0.709 0.66935416 0.66935234 -2.9973858e-07 -0.079211516 -0.079211516 -0.079211516 - 7100 0.71 0.66945968 0.66945793 -3.5866093e-07 -0.079268042 -0.079268042 -0.079268042 - 7110 0.711 0.66956493 0.66956325 -4.1031703e-07 -0.079324431 -0.079324431 -0.079324431 - 7120 0.712 0.6696699 0.66966831 -4.5365227e-07 -0.079380685 -0.079380685 -0.079380685 - 7130 0.713 0.6697746 0.6697731 -4.877853e-07 -0.079436803 -0.079436803 -0.079436803 - 7140 0.714 0.66987902 0.66987762 -5.1202608e-07 -0.079492786 -0.079492786 -0.079492786 - 7150 0.715 0.66998318 0.66998188 -5.2588991e-07 -0.079548634 -0.079548634 -0.079548634 - 7160 0.716 0.67008707 0.67008587 -5.2910725e-07 -0.079604347 -0.079604347 -0.079604347 - 7170 0.717 0.67019069 0.6701896 -5.2162911e-07 -0.079659926 -0.079659926 -0.079659926 - 7180 0.718 0.67029404 0.67029305 -5.0362782e-07 -0.07971537 -0.07971537 -0.07971537 - 7190 0.719 0.67039713 0.67039624 -4.7549322e-07 -0.07977068 -0.07977068 -0.07977068 - 7200 0.72 0.67049996 0.67049916 -4.3782437e-07 -0.079825856 -0.079825856 -0.079825856 - 7210 0.721 0.67060253 0.67060181 -3.9141694e-07 -0.079880898 -0.079880898 -0.079880898 - 7220 0.722 0.67070484 0.67070419 -3.3724651e-07 -0.079935807 -0.079935807 -0.079935807 - 7230 0.723 0.67080689 0.6708063 -2.7644818e-07 -0.079990583 -0.079990583 -0.079990583 - 7240 0.724 0.67090868 0.67090814 -2.1029284e-07 -0.080045226 -0.080045226 -0.080045226 - 7250 0.725 0.67101022 0.67100972 -1.4016069e-07 -0.080099736 -0.080099736 -0.080099736 - 7260 0.726 0.67111151 0.67111102 -6.7512524e-08 -0.080154113 -0.080154113 -0.080154113 - 7270 0.727 0.67121254 0.67121205 6.1407051e-09 -0.080208359 -0.080208359 -0.080208359 - 7280 0.728 0.67131331 0.67131281 7.9269275e-08 -0.080262472 -0.080262472 -0.080262472 - 7290 0.729 0.67141384 0.67141331 1.5035647e-07 -0.080316453 -0.080316453 -0.080316453 - 7300 0.73 0.67151411 0.67151354 2.1793008e-07 -0.080370303 -0.080370303 -0.080370303 - 7310 0.731 0.67161412 0.6716135 2.805929e-07 -0.080424022 -0.080424022 -0.080424022 - 7320 0.732 0.67171389 0.6717132 3.370517e-07 -0.080477609 -0.080477609 -0.080477609 - 7330 0.733 0.6718134 0.67181263 3.8614399e-07 -0.080531065 -0.080531065 -0.080531065 - 7340 0.734 0.67191266 0.67191181 4.2686203e-07 -0.080584391 -0.080584391 -0.080584391 - 7350 0.735 0.67201166 0.67201072 4.5837364e-07 -0.080637587 -0.080637587 -0.080637587 - 7360 0.736 0.67211041 0.67210937 4.8003926e-07 -0.080690652 -0.080690652 -0.080690652 - 7370 0.737 0.67220891 0.67220776 4.9142511e-07 -0.080743587 -0.080743587 -0.080743587 - 7380 0.738 0.67230715 0.6723059 4.9231193e-07 -0.080796393 -0.080796393 -0.080796393 - 7390 0.739 0.67240514 0.67240378 4.8269932e-07 -0.080849069 -0.080849069 -0.080849069 - 7400 0.74 0.67250287 0.67250142 4.6280552e-07 -0.080901616 -0.080901616 -0.080901616 - 7410 0.741 0.67260034 0.67259879 4.3306257e-07 -0.080954034 -0.080954034 -0.080954034 - 7420 0.742 0.67269756 0.67269592 3.941071e-07 -0.081006323 -0.081006323 -0.081006323 - 7430 0.743 0.67279451 0.6727928 3.467668e-07 -0.081058483 -0.081058483 -0.081058483 - 7440 0.744 0.67289122 0.67288944 2.9204295e-07 -0.081110515 -0.081110515 -0.081110515 - 7450 0.745 0.67298766 0.67298583 2.3108931e-07 -0.08116242 -0.08116242 -0.08116242 - 7460 0.746 0.67308384 0.67308197 1.6518793e-07 -0.081214196 -0.081214196 -0.081214196 - 7470 0.747 0.67317977 0.67317787 9.572218e-08 -0.081265845 -0.081265845 -0.081265845 - 7480 0.748 0.67327544 0.67327352 2.4147794e-08 -0.081317366 -0.081317366 -0.081317366 - 7490 0.749 0.67337086 0.67336894 -4.8037625e-08 -0.08136876 -0.08136876 -0.08136876 - 7500 0.75 0.67346601 0.67346411 -1.1932593e-07 -0.081420027 -0.081420027 -0.081420027 - 7510 0.751 0.67356092 0.67355904 -1.8822994e-07 -0.081471168 -0.081471168 -0.081471168 - 7520 0.752 0.67365556 0.67365373 -2.5331452e-07 -0.081522182 -0.081522182 -0.081522182 - 7530 0.753 0.67374996 0.67374818 -3.1322649e-07 -0.08157307 -0.08157307 -0.08157307 - 7540 0.754 0.6738441 0.67384239 -3.6672281e-07 -0.081623832 -0.081623832 -0.081623832 - 7550 0.755 0.67393798 0.67393636 -4.1269647e-07 -0.081674468 -0.081674468 -0.081674468 - 7560 0.756 0.67403162 0.67403008 -4.5019948e-07 -0.081724979 -0.081724979 -0.081724979 - 7570 0.757 0.67412501 0.67412356 -4.7846249e-07 -0.081775364 -0.081775364 -0.081775364 - 7580 0.758 0.67421815 0.6742168 -4.9691069e-07 -0.081825624 -0.081825624 -0.081825624 - 7590 0.759 0.67431105 0.6743098 -5.051756e-07 -0.08187576 -0.08187576 -0.08187576 - 7600 0.76 0.67440371 0.67440255 -5.0310252e-07 -0.081925771 -0.081925771 -0.081925771 - 7610 0.761 0.67449612 0.67449506 -4.9075352e-07 -0.081975657 -0.081975657 -0.081975657 - 7620 0.762 0.67458829 0.67458733 -4.6840587e-07 -0.08202542 -0.08202542 -0.08202542 - 7630 0.763 0.67468022 0.67467935 -4.3654593e-07 -0.082075059 -0.082075059 -0.082075059 - 7640 0.764 0.67477191 0.67477113 -3.9585872e-07 -0.082124574 -0.082124574 -0.082124574 - 7650 0.765 0.67486337 0.67486266 -3.4721328e-07 -0.082173965 -0.082173965 -0.082173965 - 7660 0.766 0.67495459 0.67495394 -2.9164422e-07 -0.082223234 -0.082223234 -0.082223234 - 7670 0.767 0.67504557 0.67504498 -2.303298e-07 -0.082272379 -0.082272379 -0.082272379 - 7680 0.768 0.67513633 0.67513577 -1.6456699e-07 -0.082321402 -0.082321402 -0.082321402 - 7690 0.769 0.67522685 0.67522631 -9.574414e-08 -0.082370302 -0.082370302 -0.082370302 - 7700 0.77 0.67531714 0.67531661 -2.5311649e-08 -0.08241908 -0.08241908 -0.08241908 - 7710 0.771 0.6754072 0.67540667 4.5248535e-08 -0.082467737 -0.082467737 -0.082467737 - 7720 0.772 0.67549703 0.67549648 1.1445412e-07 -0.082516271 -0.082516271 -0.082516271 - 7730 0.773 0.67558663 0.67558605 1.808536e-07 -0.082564684 -0.082564684 -0.082564684 - 7740 0.774 0.67567601 0.67567537 2.4305674e-07 -0.082612975 -0.082612975 -0.082612975 - 7750 0.775 0.67576515 0.67576445 2.9976375e-07 -0.082661145 -0.082661145 -0.082661145 - 7760 0.776 0.67585406 0.67585329 3.4979244e-07 -0.082709195 -0.082709195 -0.082709195 - 7770 0.777 0.67594274 0.6759419 3.92103e-07 -0.082757124 -0.082757124 -0.082757124 - 7780 0.778 0.67603119 0.67603026 4.2581967e-07 -0.082804933 -0.082804933 -0.082804933 - 7790 0.779 0.67611941 0.67611839 4.5024891e-07 -0.082852621 -0.082852621 -0.082852621 - 7800 0.78 0.6762074 0.67620628 4.6489385e-07 -0.08290019 -0.08290019 -0.08290019 - 7810 0.781 0.67629516 0.67629394 4.694644e-07 -0.082947638 -0.082947638 -0.082947638 - 7820 0.782 0.67638268 0.67638136 4.6388312e-07 -0.082994968 -0.082994968 -0.082994968 - 7830 0.783 0.67646997 0.67646856 4.4828658e-07 -0.083042178 -0.083042178 -0.083042178 - 7840 0.784 0.67655703 0.67655553 4.2302214e-07 -0.083089269 -0.083089269 -0.083089269 - 7850 0.785 0.67664386 0.67664227 3.886404e-07 -0.083136242 -0.083136242 -0.083136242 - 7860 0.786 0.67673045 0.67672878 3.4588328e-07 -0.083183096 -0.083183096 -0.083183096 - 7870 0.787 0.67681681 0.67681507 2.9566809e-07 -0.083229832 -0.083229832 -0.083229832 - 7880 0.788 0.67690293 0.67690114 2.3906798e-07 -0.083276449 -0.083276449 -0.083276449 - 7890 0.789 0.67698882 0.67698698 1.7728904e-07 -0.083322949 -0.083322949 -0.083322949 - 7900 0.79 0.67707447 0.6770726 1.1164468e-07 -0.083369331 -0.083369331 -0.083369331 - 7910 0.791 0.67715989 0.677158 4.3527757e-08 -0.083415596 -0.083415596 -0.083415596 - 7920 0.792 0.67724508 0.67724318 -2.5618985e-08 -0.083461744 -0.083461744 -0.083461744 - 7930 0.793 0.67733003 0.67732815 -9.4333425e-08 -0.083507775 -0.083507775 -0.083507775 - 7940 0.794 0.67741475 0.67741289 -1.61165e-07 -0.083553689 -0.083553689 -0.083553689 - 7950 0.795 0.67749923 0.67749741 -2.2470534e-07 -0.083599487 -0.083599487 -0.083599487 - 7960 0.796 0.67758349 0.67758172 -2.83618e-07 -0.083645169 -0.083645169 -0.083645169 - 7970 0.797 0.67766751 0.67766581 -3.3666656e-07 -0.083690735 -0.083690735 -0.083690735 - 7980 0.798 0.67775131 0.67774967 -3.8274072e-07 -0.083736185 -0.083736185 -0.083736185 - 7990 0.799 0.67783488 0.67783332 -4.2087952e-07 -0.083781519 -0.083781519 -0.083781519 - 8000 0.8 0.67791822 0.67791675 -4.5029151e-07 -0.083826738 -0.083826738 -0.083826738 - 8010 0.801 0.67800134 0.67799996 -4.7037125e-07 -0.083871843 -0.083871843 -0.083871843 - 8020 0.802 0.67808423 0.67808295 -4.8071186e-07 -0.083916832 -0.083916832 -0.083916832 - 8030 0.803 0.67816691 0.67816572 -4.8111332e-07 -0.083961707 -0.083961707 -0.083961707 - 8040 0.804 0.67824936 0.67824827 -4.7158646e-07 -0.084006467 -0.084006467 -0.084006467 - 8050 0.805 0.67833159 0.6783306 -4.5235237e-07 -0.084051114 -0.084051114 -0.084051114 - 8060 0.806 0.67841361 0.6784127 -4.2383744e-07 -0.084095646 -0.084095646 -0.084095646 - 8070 0.807 0.67849541 0.67849458 -3.8666401e-07 -0.084140065 -0.084140065 -0.084140065 - 8080 0.808 0.67857699 0.67857624 -3.416369e-07 -0.08418437 -0.08418437 -0.08418437 - 8090 0.809 0.67865837 0.67865767 -2.8972605e-07 -0.084228563 -0.084228563 -0.084228563 - 8100 0.81 0.67873953 0.67873888 -2.3204574e-07 -0.084272642 -0.084272642 -0.084272642 - 8110 0.811 0.67882047 0.67881987 -1.6983071e-07 -0.084316609 -0.084316609 -0.084316609 - 8120 0.812 0.67890121 0.67890063 -1.0440976e-07 -0.084360463 -0.084360463 -0.084360463 - 8130 0.813 0.67898174 0.67898117 -3.7177474e-08 -0.084404204 -0.084404204 -0.084404204 - 8140 0.814 0.67906206 0.67906149 3.043557e-08 -0.084447834 -0.084447834 -0.084447834 - 8150 0.815 0.67914218 0.67914159 9.6993173e-08 -0.084491352 -0.084491352 -0.084491352 - 8160 0.816 0.67922208 0.67922146 1.6108406e-07 -0.084534759 -0.084534759 -0.084534759 - 8170 0.817 0.67930178 0.67930112 2.2135179e-07 -0.084578054 -0.084578054 -0.084578054 - 8180 0.818 0.67938127 0.67938055 2.7652357e-07 -0.084621237 -0.084621237 -0.084621237 - 8190 0.819 0.67946055 0.67945976 3.2543709e-07 -0.08466431 -0.08466431 -0.08466431 - 8200 0.82 0.67953962 0.67953876 3.6706513e-07 -0.084707273 -0.084707273 -0.084707273 - 8210 0.821 0.67961848 0.67961754 4.0053718e-07 -0.084750125 -0.084750125 -0.084750125 - 8220 0.822 0.67969714 0.67969611 4.2515771e-07 -0.084792866 -0.084792866 -0.084792866 - 8230 0.823 0.67977558 0.67977446 4.4042071e-07 -0.084835498 -0.084835498 -0.084835498 - 8240 0.824 0.67985382 0.67985261 4.4602016e-07 -0.08487802 -0.08487802 -0.08487802 - 8250 0.825 0.67993184 0.67993054 4.4185622e-07 -0.084920432 -0.084920432 -0.084920432 - 8260 0.826 0.68000966 0.68000826 4.2803707e-07 -0.084962736 -0.084962736 -0.084962736 - 8270 0.827 0.68008726 0.68008577 4.0487627e-07 -0.08500493 -0.08500493 -0.08500493 - 8280 0.828 0.68016465 0.68016308 3.7288575e-07 -0.085047015 -0.085047015 -0.085047015 - 8290 0.829 0.68024183 0.68024019 3.327646e-07 -0.085088991 -0.085088991 -0.085088991 - 8300 0.83 0.6803188 0.68031709 2.8538389e-07 -0.08513086 -0.08513086 -0.08513086 - 8310 0.831 0.68039556 0.68039379 2.3176784e-07 -0.08517262 -0.08517262 -0.08517262 - 8320 0.832 0.6804721 0.68047028 1.7307173e-07 -0.085214272 -0.085214272 -0.085214272 - 8330 0.833 0.68054843 0.68054658 1.1055705e-07 -0.085255816 -0.085255816 -0.085255816 - 8340 0.834 0.68062454 0.68062268 4.5564469e-08 -0.085297253 -0.085297253 -0.085297253 - 8350 0.835 0.68070045 0.68069858 -2.0514929e-08 -0.085338583 -0.085338583 -0.085338583 - 8360 0.836 0.68077614 0.68077428 -8.6269392e-08 -0.085379805 -0.085379805 -0.085379805 - 8370 0.837 0.68085162 0.68084978 -1.5029666e-07 -0.085420921 -0.085420921 -0.085420921 - 8380 0.838 0.68092689 0.68092509 -2.1123389e-07 -0.08546193 -0.08546193 -0.08546193 - 8390 0.839 0.68100195 0.6810002 -2.6778667e-07 -0.085502833 -0.085502833 -0.085502833 - 8400 0.84 0.6810768 0.68107511 -3.1875659e-07 -0.08554363 -0.08554363 -0.08554363 - 8410 0.841 0.68115145 0.68114982 -3.6306666e-07 -0.085584321 -0.085584321 -0.085584321 - 8420 0.842 0.68122589 0.68122434 -3.9978412e-07 -0.085624906 -0.085624906 -0.085624906 - 8430 0.843 0.68130012 0.68129865 -4.2814015e-07 -0.085665386 -0.085665386 -0.085665386 - 8440 0.844 0.68137415 0.68137277 -4.4754604e-07 -0.08570576 -0.08570576 -0.08570576 - 8450 0.845 0.68144798 0.68144669 -4.5760548e-07 -0.08574603 -0.08574603 -0.08574603 - 8460 0.846 0.6815216 0.68152041 -4.5812272e-07 -0.085786195 -0.085786195 -0.085786195 - 8470 0.847 0.68159503 0.68159393 -4.4910642e-07 -0.085826255 -0.085826255 -0.085826255 - 8480 0.848 0.68166826 0.68166725 -4.3076917e-07 -0.08586621 -0.08586621 -0.08586621 - 8490 0.849 0.6817413 0.68174037 -4.0352254e-07 -0.085906062 -0.085906062 -0.085906062 - 8500 0.85 0.68181413 0.68181328 -3.6796802e-07 -0.08594581 -0.08594581 -0.08594581 - 8510 0.851 0.68188678 0.681886 -3.2488376e-07 -0.085985454 -0.085985454 -0.085985454 - 8520 0.852 0.68195923 0.68195851 -2.7520768e-07 -0.086024995 -0.086024995 -0.086024995 - 8530 0.853 0.68203149 0.68203082 -2.2001708e-07 -0.086064432 -0.086064432 -0.086064432 - 8540 0.854 0.68210356 0.68210292 -1.6050534e-07 -0.086103767 -0.086103767 -0.086103767 - 8550 0.855 0.68217544 0.68217483 -9.7956193e-08 -0.086142998 -0.086142998 -0.086142998 - 8560 0.856 0.68224714 0.68224653 -3.3716011e-08 -0.086182128 -0.086182128 -0.086182128 - 8570 0.857 0.68231864 0.68231803 3.0835115e-08 -0.086221154 -0.086221154 -0.086221154 - 8580 0.858 0.68238996 0.68238933 9.4313031e-08 -0.086260079 -0.086260079 -0.086260079 - 8590 0.859 0.68246108 0.68246043 1.553592e-07 -0.086298902 -0.086298902 -0.086298902 - 8600 0.86 0.68253203 0.68253133 2.1266981e-07 -0.086337623 -0.086337623 -0.086337623 - 8610 0.861 0.68260278 0.68260203 2.6502363e-07 -0.086376243 -0.086376243 -0.086376243 - 8620 0.862 0.68267334 0.68267253 3.1130807e-07 -0.086414761 -0.086414761 -0.086414761 - 8630 0.863 0.68274372 0.68274284 3.505429e-07 -0.086453179 -0.086453179 -0.086453179 - 8640 0.864 0.68281391 0.68281295 3.8190104e-07 -0.086491495 -0.086491495 -0.086491495 - 8650 0.865 0.68288391 0.68288286 4.0472606e-07 -0.086529711 -0.086529711 -0.086529711 - 8660 0.866 0.68295373 0.68295259 4.1854599e-07 -0.086567827 -0.086567827 -0.086567827 - 8670 0.867 0.68302335 0.68302212 4.2308313e-07 -0.086605843 -0.086605843 -0.086605843 - 8680 0.868 0.68309278 0.68309146 4.1825971e-07 -0.086643758 -0.086643758 -0.086643758 - 8690 0.869 0.68316202 0.68316062 4.0419917e-07 -0.086681574 -0.086681574 -0.086681574 - 8700 0.87 0.68323107 0.68322958 3.8122323e-07 -0.086719291 -0.086719291 -0.086719291 - 8710 0.871 0.68329993 0.68329837 3.4984454e-07 -0.086756908 -0.086756908 -0.086756908 - 8720 0.872 0.6833686 0.68336696 3.1075544e-07 -0.086794427 -0.086794427 -0.086794427 - 8730 0.873 0.68343708 0.68343538 2.6481266e-07 -0.086831846 -0.086831846 -0.086831846 - 8740 0.874 0.68350536 0.68350361 2.1301869e-07 -0.086869167 -0.086869167 -0.086869167 - 8750 0.875 0.68357345 0.68357166 1.5649988e-07 -0.086906389 -0.086906389 -0.086906389 - 8760 0.876 0.68364135 0.68363953 9.6482097e-08 -0.086943514 -0.086943514 -0.086943514 - 8770 0.877 0.68370906 0.68370722 3.4264059e-08 -0.08698054 -0.08698054 -0.08698054 - 8780 0.878 0.68377658 0.68377474 -2.8810669e-08 -0.087017469 -0.087017469 -0.087017469 - 8790 0.879 0.6838439 0.68384207 -9.1382705e-08 -0.0870543 -0.0870543 -0.0870543 - 8800 0.88 0.68391103 0.68390923 -1.5210615e-07 -0.087091034 -0.087091034 -0.087091034 - 8810 0.881 0.68397797 0.6839762 -2.0967754e-07 -0.08712767 -0.08712767 -0.08712767 - 8820 0.882 0.68404473 0.684043 -2.6286386e-07 -0.08716421 -0.08716421 -0.08716421 - 8830 0.883 0.68411129 0.68410963 -3.1052897e-07 -0.087200653 -0.087200653 -0.087200653 - 8840 0.884 0.68417767 0.68417607 -3.5165794e-07 -0.087237 -0.087237 -0.087237 - 8850 0.885 0.68424386 0.68424234 -3.8537866e-07 -0.087273251 -0.087273251 -0.087273251 - 8860 0.886 0.68430987 0.68430842 -4.1098047e-07 -0.087309405 -0.087309405 -0.087309405 - 8870 0.887 0.68437569 0.68437433 -4.2792911e-07 -0.087345464 -0.087345464 -0.087345464 - 8880 0.888 0.68444133 0.68444006 -4.3587796e-07 -0.087381427 -0.087381427 -0.087381427 - 8890 0.889 0.68450679 0.68450561 -4.3467519e-07 -0.087417295 -0.087417295 -0.087417295 - 8900 0.89 0.68457207 0.68457098 -4.243667e-07 -0.087453068 -0.087453068 -0.087453068 - 8910 0.891 0.68463718 0.68463616 -4.0519472e-07 -0.087488746 -0.087488746 -0.087488746 - 8920 0.892 0.6847021 0.68470117 -3.7759228e-07 -0.087524329 -0.087524329 -0.087524329 - 8930 0.893 0.68476685 0.68476599 -3.4217351e-07 -0.087559817 -0.087559817 -0.087559817 - 8940 0.894 0.68483143 0.68483063 -2.9972001e-07 -0.087595211 -0.087595211 -0.087595211 - 8950 0.895 0.68489583 0.68489509 -2.5116375e-07 -0.087630512 -0.087630512 -0.087630512 - 8960 0.896 0.68496007 0.68495936 -1.975666e-07 -0.087665718 -0.087665718 -0.087665718 - 8970 0.897 0.68502413 0.68502346 -1.4009717e-07 -0.087700831 -0.087700831 -0.087700831 - 8980 0.898 0.68508802 0.68508737 -8.0005408e-08 -0.08773585 -0.08773585 -0.08773585 - 8990 0.899 0.68515174 0.68515109 -1.8595382e-08 -0.087770776 -0.087770776 -0.087770776 - 9000 0.9 0.68521529 0.68521464 4.2802966e-08 -0.087805609 -0.087805609 -0.087805609 - 9010 0.901 0.68527867 0.685278 1.0286263e-07 -0.087840349 -0.087840349 -0.087840349 - 9020 0.902 0.68534188 0.68534119 1.6028822e-07 -0.087874996 -0.087874996 -0.087874996 - 9030 0.903 0.68540493 0.68540419 2.1384393e-07 -0.087909551 -0.087909551 -0.087909551 - 9040 0.904 0.68546781 0.68546701 2.6238014e-07 -0.087944014 -0.087944014 -0.087944014 - 9050 0.905 0.68553051 0.68552966 3.0485816e-07 -0.087978385 -0.087978385 -0.087978385 - 9060 0.906 0.68559305 0.68559213 3.4037244e-07 -0.088012665 -0.088012665 -0.088012665 - 9070 0.907 0.68565542 0.68565442 3.6817e-07 -0.088046852 -0.088046852 -0.088046852 - 9080 0.908 0.68571762 0.68571654 3.8766636e-07 -0.088080949 -0.088080949 -0.088080949 - 9090 0.909 0.68577965 0.68577848 3.9845796e-07 -0.088114954 -0.088114954 -0.088114954 - 9100 0.91 0.68584151 0.68584025 4.0033051e-07 -0.088148868 -0.088148868 -0.088148868 - 9110 0.911 0.6859032 0.68590186 3.9326329e-07 -0.088182692 -0.088182692 -0.088182692 - 9120 0.912 0.68596471 0.68596329 3.7742924e-07 -0.088216425 -0.088216425 -0.088216425 - 9130 0.913 0.68602606 0.68602455 3.5319086e-07 -0.088250067 -0.088250067 -0.088250067 - 9140 0.914 0.68608723 0.68608565 3.2109199e-07 -0.08828362 -0.08828362 -0.08828362 - 9150 0.915 0.68614823 0.68614659 2.8184568e-07 -0.088317083 -0.088317083 -0.088317083 - 9160 0.916 0.68620905 0.68620735 2.3631841e-07 -0.088350456 -0.088350456 -0.088350456 - 9170 0.917 0.6862697 0.68626796 1.8551105e-07 -0.08838374 -0.08838374 -0.08838374 - 9180 0.918 0.68633018 0.6863284 1.3053687e-07 -0.088416934 -0.088416934 -0.088416934 - 9190 0.919 0.68639049 0.68638868 7.2597189e-08 -0.088450039 -0.088450039 -0.088450039 - 9200 0.92 0.68645062 0.6864488 1.2955167e-08 -0.088483056 -0.088483056 -0.088483056 - 9210 0.921 0.68651058 0.68650876 -4.7091734e-08 -0.088515984 -0.088515984 -0.088515984 - 9220 0.922 0.68657036 0.68656856 -1.0623996e-07 -0.088548823 -0.088548823 -0.088548823 - 9230 0.923 0.68662998 0.6866282 -1.6320817e-07 -0.088581574 -0.088581574 -0.088581574 - 9240 0.924 0.68668942 0.68668769 -2.1676499e-07 -0.088614237 -0.088614237 -0.088614237 - 9250 0.925 0.68674869 0.68674701 -2.6575568e-07 -0.088646812 -0.088646812 -0.088646812 - 9260 0.926 0.68680779 0.68680617 -3.0912704e-07 -0.0886793 -0.0886793 -0.0886793 - 9270 0.927 0.68686673 0.68686517 -3.4595009e-07 -0.0887117 -0.0887117 -0.0887117 - 9280 0.928 0.6869255 0.68692401 -3.7544002e-07 -0.088744013 -0.088744013 -0.088744013 - 9290 0.929 0.6869841 0.68698269 -3.9697293e-07 -0.088776239 -0.088776239 -0.088776239 - 9300 0.93 0.68704254 0.68704121 -4.1009912e-07 -0.088808378 -0.088808378 -0.088808378 - 9310 0.931 0.68710081 0.68709956 -4.1455252e-07 -0.088840431 -0.088840431 -0.088840431 - 9320 0.932 0.68715892 0.68715776 -4.1025607e-07 -0.088872397 -0.088872397 -0.088872397 - 9330 0.933 0.68721687 0.68721579 -3.9732309e-07 -0.088904277 -0.088904277 -0.088904277 - 9340 0.934 0.68727466 0.68727366 -3.7605442e-07 -0.088936071 -0.088936071 -0.088936071 - 9350 0.935 0.68733229 0.68733137 -3.4693151e-07 -0.088967779 -0.088967779 -0.088967779 - 9360 0.936 0.68738977 0.68738891 -3.1060559e-07 -0.088999401 -0.088999401 -0.088999401 - 9370 0.937 0.68744709 0.68744628 -2.678832e-07 -0.089030938 -0.089030938 -0.089030938 - 9380 0.938 0.68750426 0.6875035 -2.1970834e-07 -0.08906239 -0.08906239 -0.08906239 - 9390 0.939 0.68756127 0.68756055 -1.671416e-07 -0.089093757 -0.089093757 -0.089093757 - 9400 0.94 0.68761812 0.68761743 -1.1133694e-07 -0.089125039 -0.089125039 -0.089125039 - 9410 0.941 0.68767483 0.68767415 -5.3516312e-08 -0.089156237 -0.089156237 -0.089156237 - 9420 0.942 0.68773138 0.6877307 5.0570456e-09 -0.08918735 -0.08918735 -0.08918735 - 9430 0.943 0.68778778 0.68778709 6.3106191e-08 -0.089218379 -0.089218379 -0.089218379 - 9440 0.944 0.68784403 0.68784332 1.1936833e-07 -0.089249324 -0.089249324 -0.089249324 - 9450 0.945 0.68790013 0.68789939 1.7262227e-07 -0.089280185 -0.089280185 -0.089280185 - 9460 0.946 0.68795608 0.68795529 2.21715e-07 -0.089310962 -0.089310962 -0.089310962 - 9470 0.947 0.68801188 0.68801103 2.6558658e-07 -0.089341657 -0.089341657 -0.089341657 - 9480 0.948 0.68806752 0.68806662 3.0329316e-07 -0.089372267 -0.089372267 -0.089372267 - 9490 0.949 0.68812302 0.68812204 3.3402726e-07 -0.089402795 -0.089402795 -0.089402795 - 9500 0.95 0.68817836 0.6881773 3.5713511e-07 -0.08943324 -0.08943324 -0.08943324 - 9510 0.951 0.68823355 0.68823241 3.721306e-07 -0.089463603 -0.089463603 -0.089463603 - 9520 0.952 0.68828858 0.68828737 3.7870557e-07 -0.089493883 -0.089493883 -0.089493883 - 9530 0.953 0.68834347 0.68834217 3.7673613e-07 -0.08952408 -0.08952408 -0.08952408 - 9540 0.954 0.68839819 0.68839682 3.6628503e-07 -0.089554196 -0.089554196 -0.089554196 - 9550 0.955 0.68845277 0.68845131 3.4759992e-07 -0.08958423 -0.08958423 -0.08958423 - 9560 0.956 0.68850719 0.68850566 3.2110753e-07 -0.089614182 -0.089614182 -0.089614182 - 9570 0.957 0.68856145 0.68855986 2.8740406e-07 -0.089644053 -0.089644053 -0.089644053 - 9580 0.958 0.68861556 0.68861391 2.4724178e-07 -0.089673843 -0.089673843 -0.089673843 - 9590 0.959 0.68866951 0.68866781 2.0151231e-07 -0.089703551 -0.089703551 -0.089703551 - 9600 0.96 0.6887233 0.68872157 1.5122687e-07 -0.089733179 -0.089733179 -0.089733179 - 9610 0.961 0.68877694 0.68877518 9.749396e-08 -0.089762726 -0.089762726 -0.089762726 - 9620 0.962 0.68883043 0.68882864 4.1494944e-08 -0.089792192 -0.089792192 -0.089792192 - 9630 0.963 0.68888376 0.68888197 -1.5541893e-08 -0.089821578 -0.089821578 -0.089821578 - 9640 0.964 0.68893693 0.68893515 -7.2368278e-08 -0.089850884 -0.089850884 -0.089850884 - 9650 0.965 0.68898995 0.68898818 -1.2774327e-07 -0.089880111 -0.089880111 -0.089880111 - 9660 0.966 0.68904281 0.68904108 -1.8046035e-07 -0.089909257 -0.089909257 -0.089909257 - 9670 0.967 0.68909552 0.68909383 -2.2937375e-07 -0.089938324 -0.089938324 -0.089938324 - 9680 0.968 0.68914808 0.68914644 -2.7342333e-07 -0.089967312 -0.089967312 -0.089967312 - 9690 0.969 0.68920048 0.6891989 -3.1165765e-07 -0.08999622 -0.08999622 -0.08999622 - 9700 0.97 0.68925273 0.68925122 -3.4325447e-07 -0.09002505 -0.09002505 -0.09002505 - 9710 0.971 0.68930484 0.6893034 -3.6753853e-07 -0.090053801 -0.090053801 -0.090053801 - 9720 0.972 0.6893568 0.68935543 -3.8399599e-07 -0.090082473 -0.090082473 -0.090082473 - 9730 0.973 0.6894086 0.68940732 -3.9228536e-07 -0.090111067 -0.090111067 -0.090111067 - 9740 0.974 0.68946027 0.68945906 -3.9224459e-07 -0.090139582 -0.090139582 -0.090139582 - 9750 0.975 0.68951179 0.68951066 -3.8389426e-07 -0.09016802 -0.09016802 -0.09016802 - 9760 0.976 0.68956316 0.68956211 -3.6743677e-07 -0.09019638 -0.09019638 -0.09019638 - 9770 0.977 0.68961439 0.68961341 -3.432515e-07 -0.090224662 -0.090224662 -0.090224662 - 9780 0.978 0.68966548 0.68966457 -3.1188616e-07 -0.090252867 -0.090252867 -0.090252867 - 9790 0.979 0.68971643 0.68971558 -2.7404444e-07 -0.090280995 -0.090280995 -0.090280995 - 9800 0.98 0.68976724 0.68976644 -2.3057029e-07 -0.090309045 -0.090309045 -0.090309045 - 9810 0.981 0.68981792 0.68981715 -1.8242913e-07 -0.090337019 -0.090337019 -0.090337019 - 9820 0.982 0.68986845 0.68986772 -1.3068644e-07 -0.090364916 -0.090364916 -0.090364916 - 9830 0.983 0.68991885 0.68991813 -7.6484243e-08 -0.090392736 -0.090392736 -0.090392736 - 9840 0.984 0.68996912 0.6899684 -2.1015886e-08 -0.09042048 -0.09042048 -0.09042048 - 9850 0.985 0.69001924 0.69001853 3.4500202e-08 -0.090448148 -0.090448148 -0.090448148 - 9860 0.986 0.69006924 0.6900685 8.8847271e-08 -0.090475741 -0.090475741 -0.090475741 - 9870 0.987 0.69011909 0.69011833 1.4083692e-07 -0.090503257 -0.090503257 -0.090503257 - 9880 0.988 0.69016881 0.69016801 1.8933509e-07 -0.090530698 -0.090530698 -0.090530698 - 9890 0.989 0.6902184 0.69021755 2.3328683e-07 -0.090558063 -0.090558063 -0.090558063 - 9900 0.99 0.69026785 0.69026695 2.7173925e-07 -0.090585353 -0.090585353 -0.090585353 - 9910 0.991 0.69031717 0.6903162 3.038622e-07 -0.090612569 -0.090612569 -0.090612569 - 9920 0.992 0.69036635 0.69036531 3.2896626e-07 -0.090639709 -0.090639709 -0.090639709 - 9930 0.993 0.69041539 0.69041428 3.4651751e-07 -0.090666775 -0.090666775 -0.090666775 - 9940 0.994 0.69046429 0.69046311 3.56149e-07 -0.090693766 -0.090693766 -0.090693766 - 9950 0.995 0.69051306 0.6905118 3.5766835e-07 -0.090720683 -0.090720683 -0.090720683 - 9960 0.996 0.69056169 0.69056035 3.5106169e-07 -0.090747526 -0.090747526 -0.090747526 - 9970 0.997 0.69061018 0.69060877 3.3649353e-07 -0.090774295 -0.090774295 -0.090774295 - 9980 0.998 0.69065854 0.69065705 3.143028e-07 -0.09080099 -0.09080099 -0.09080099 - 9990 0.999 0.69070675 0.6907052 2.8499502e-07 -0.090827612 -0.090827612 -0.090827612 - 10000 1 0.69075483 0.69075321 2.4923086e-07 -0.09085416 -0.09085416 -0.09085416 - 10010 1.001 0.69080276 0.6908011 2.0781127e-07 -0.090880635 -0.090880635 -0.090880635 - 10020 1.002 0.69085056 0.69084885 1.6165961e-07 -0.090907037 -0.090907037 -0.090907037 - 10030 1.003 0.69089821 0.69089648 1.118011e-07 -0.090933367 -0.090933367 -0.090933367 - 10040 1.004 0.69094572 0.69094397 5.9340085e-08 -0.090959623 -0.090959623 -0.090959623 - 10050 1.005 0.6909931 0.69099134 5.4355473e-09 -0.090985807 -0.090985807 -0.090985807 - 10060 1.006 0.69104033 0.69103857 -4.8724427e-08 -0.091011919 -0.091011919 -0.091011919 - 10070 1.007 0.69108743 0.69108568 -1.0194886e-07 -0.091037959 -0.091037959 -0.091037959 - 10080 1.008 0.69113438 0.69113266 -1.5307005e-07 -0.091063927 -0.091063927 -0.091063927 - 10090 1.009 0.6911812 0.69117952 -2.0096923e-07 -0.091089823 -0.091089823 -0.091089823 - 10100 1.01 0.69122788 0.69122624 -2.4460104e-07 -0.091115648 -0.091115648 -0.091115648 - 10110 1.011 0.69127443 0.69127284 -2.8301635e-07 -0.091141401 -0.091141401 -0.091141401 - 10120 1.012 0.69132084 0.69131931 -3.1538295e-07 -0.091167083 -0.091167083 -0.091167083 - 10130 1.013 0.69136711 0.69136565 -3.4100363e-07 -0.091192693 -0.091192693 -0.091192693 - 10140 1.014 0.69141325 0.69141186 -3.5933117e-07 -0.091218233 -0.091218233 -0.091218233 - 10150 1.015 0.69145926 0.69145794 -3.699801e-07 -0.091243703 -0.091243703 -0.091243703 - 10160 1.016 0.69150514 0.6915039 -3.7273481e-07 -0.091269102 -0.091269102 -0.091269102 - 10170 1.017 0.69155088 0.69154972 -3.6755394e-07 -0.09129443 -0.09129443 -0.09129443 - 10180 1.018 0.6915965 0.69159541 -3.5457093e-07 -0.091319688 -0.091319688 -0.091319688 - 10190 1.019 0.69164199 0.69164097 -3.3409064e-07 -0.091344877 -0.091344877 -0.091344877 - 10200 1.02 0.69168736 0.6916864 -3.0658233e-07 -0.091369995 -0.091369995 -0.091369995 - 10210 1.021 0.69173259 0.69173169 -2.7266894e-07 -0.091395044 -0.091395044 -0.091395044 - 10220 1.022 0.69177771 0.69177686 -2.3311303e-07 -0.091420023 -0.091420023 -0.091420023 - 10230 1.023 0.6918227 0.69182189 -1.8879967e-07 -0.091444933 -0.091444933 -0.091444933 - 10240 1.024 0.69186757 0.69186679 -1.407167e-07 -0.091469774 -0.091469774 -0.091469774 - 10250 1.025 0.69191231 0.69191155 -8.993269e-08 -0.091494546 -0.091494546 -0.091494546 - 10260 1.026 0.69195693 0.69195619 -3.7573278e-08 -0.091519249 -0.091519249 -0.091519249 - 10270 1.027 0.69200144 0.69200069 1.5203814e-08 -0.091543884 -0.091543884 -0.091543884 - 10280 1.028 0.69204582 0.69204506 6.7234351e-08 -0.09156845 -0.09156845 -0.09156845 - 10290 1.029 0.69209008 0.69208929 1.1737327e-07 -0.091592948 -0.091592948 -0.091592948 - 10300 1.03 0.69213422 0.6921334 1.6451988e-07 -0.091617378 -0.091617378 -0.091617378 - 10310 1.031 0.69217824 0.69217738 2.0764205e-07 -0.09164174 -0.09164174 -0.09164174 - 10320 1.032 0.69222213 0.69222122 2.4579878e-07 -0.091666034 -0.091666034 -0.091666034 - 10330 1.033 0.69226591 0.69226494 2.7816081e-07 -0.091690261 -0.091690261 -0.091690261 - 10340 1.034 0.69230957 0.69230853 3.0402864e-07 -0.09171442 -0.09171442 -0.09171442 - 10350 1.035 0.6923531 0.692352 3.2284766e-07 -0.091738512 -0.091738512 -0.091738512 - 10360 1.036 0.69239651 0.69239534 3.3422007e-07 -0.091762537 -0.091762537 -0.091762537 - 10370 1.037 0.6924398 0.69243855 3.3791336e-07 -0.091786495 -0.091786495 -0.091786495 - 10380 1.038 0.69248296 0.69248164 3.33865e-07 -0.091810386 -0.091810386 -0.091810386 - 10390 1.039 0.69252601 0.69252461 3.2218348e-07 -0.091834211 -0.091834211 -0.091834211 - 10400 1.04 0.69256892 0.69256746 3.0314554e-07 -0.091857969 -0.091857969 -0.091857969 - 10410 1.041 0.69261172 0.69261019 2.7718967e-07 -0.091881662 -0.091881662 -0.091881662 - 10420 1.042 0.69265438 0.6926528 2.4490607e-07 -0.091905288 -0.091905288 -0.091905288 - 10430 1.043 0.69269693 0.6926953 2.0702329e-07 -0.091928848 -0.091928848 -0.091928848 - 10440 1.044 0.69273934 0.69273767 1.643918e-07 -0.091952342 -0.091952342 -0.091952342 - 10450 1.045 0.69278164 0.69277993 1.1796495e-07 -0.091975771 -0.091975771 -0.091975771 - 10460 1.046 0.6928238 0.69282208 6.8777704e-08 -0.091999135 -0.091999135 -0.091999135 - 10470 1.047 0.69286584 0.69286411 1.7923524e-08 -0.092022433 -0.092022433 -0.092022433 - 10480 1.048 0.69290776 0.69290602 -3.3469864e-08 -0.092045666 -0.092045666 -0.092045666 - 10490 1.049 0.69294955 0.69294782 -8.4265498e-08 -0.092068835 -0.092068835 -0.092068835 - 10500 1.05 0.69299121 0.69298951 -1.3334232e-07 -0.092091938 -0.092091938 -0.092091938 - 10510 1.051 0.69303276 0.69303108 -1.7961993e-07 -0.092114977 -0.092114977 -0.092114977 - 10520 1.052 0.69307417 0.69307254 -2.2208238e-07 -0.092137952 -0.092137952 -0.092137952 - 10530 1.053 0.69311547 0.69311388 -2.5980046e-07 -0.092160863 -0.092160863 -0.092160863 - 10540 1.054 0.69315664 0.69315511 -2.9195212e-07 -0.092183709 -0.092183709 -0.092183709 - 10550 1.055 0.6931977 0.69319623 -3.1784032e-07 -0.092206492 -0.092206492 -0.092206492 - 10560 1.056 0.69323863 0.69323723 -3.3690823e-07 -0.09222921 -0.09222921 -0.09222921 - 10570 1.057 0.69327945 0.69327812 -3.4875121e-07 -0.092251865 -0.092251865 -0.092251865 - 10580 1.058 0.69332014 0.69331888 -3.5312541e-07 -0.092274457 -0.092274457 -0.092274457 - 10590 1.059 0.69336073 0.69335954 -3.4995279e-07 -0.092296986 -0.092296986 -0.092296986 - 10600 1.06 0.69340119 0.69340007 -3.393225e-07 -0.092319451 -0.092319451 -0.092319451 - 10610 1.061 0.69344154 0.69344049 -3.2148851e-07 -0.092341854 -0.092341854 -0.092341854 - 10620 1.062 0.69348178 0.69348079 -2.9686361e-07 -0.092364193 -0.092364193 -0.092364193 - 10630 1.063 0.69352191 0.69352097 -2.6600991e-07 -0.09238647 -0.09238647 -0.09238647 - 10640 1.064 0.69356192 0.69356104 -2.2962607e-07 -0.092408685 -0.092408685 -0.092408685 - 10650 1.065 0.69360183 0.69360098 -1.8853149e-07 -0.092430837 -0.092430837 -0.092430837 - 10660 1.066 0.69364162 0.69364081 -1.4364793e-07 -0.092452928 -0.092452928 -0.092452928 - 10670 1.067 0.69368131 0.69368052 -9.5978821e-08 -0.092474956 -0.092474956 -0.092474956 - 10680 1.068 0.69372088 0.69372011 -4.6586875e-08 -0.092496922 -0.092496922 -0.092496922 - 10690 1.069 0.69376035 0.69375958 3.4295913e-09 -0.092518827 -0.092518827 -0.092518827 - 10700 1.07 0.69379971 0.69379893 5.2961074e-08 -0.09254067 -0.09254067 -0.09254067 - 10710 1.071 0.69383897 0.69383816 1.0091149e-07 -0.092562452 -0.092562452 -0.092562452 - 10720 1.072 0.69387811 0.69387728 1.4622244e-07 -0.092584173 -0.092584173 -0.092584173 - 10730 1.073 0.69391715 0.69391628 1.8789655e-07 -0.092605833 -0.092605833 -0.092605833 - 10740 1.074 0.69395608 0.69395516 2.2501949e-07 -0.092627432 -0.092627432 -0.092627432 - 10750 1.075 0.69399491 0.69399393 2.5677998e-07 -0.09264897 -0.09264897 -0.09264897 - 10760 1.076 0.69403362 0.69403259 2.824876e-07 -0.092670448 -0.092670448 -0.092670448 - 10770 1.077 0.69407223 0.69407113 3.0158779e-07 -0.092691865 -0.092691865 -0.092691865 - 10780 1.078 0.69411073 0.69410956 3.1367381e-07 -0.092713222 -0.092713222 -0.092713222 - 10790 1.079 0.69414911 0.69414788 3.1849546e-07 -0.092734519 -0.092734519 -0.092734519 - 10800 1.08 0.69418739 0.69418608 3.1596425e-07 -0.092755756 -0.092755756 -0.092755756 - 10810 1.081 0.69422556 0.69422418 3.0615497e-07 -0.092776933 -0.092776933 -0.092776933 - 10820 1.082 0.69426361 0.69426217 2.8930369e-07 -0.092798051 -0.092798051 -0.092798051 - 10830 1.083 0.69430156 0.69430006 2.6580209e-07 -0.092819109 -0.092819109 -0.092819109 - 10840 1.084 0.69433939 0.69433784 2.3618848e-07 -0.092840108 -0.092840108 -0.092840108 - 10850 1.085 0.69437711 0.69437551 2.0113546e-07 -0.092861048 -0.092861048 -0.092861048 - 10860 1.086 0.69441472 0.69441308 1.6143468e-07 -0.092881928 -0.092881928 -0.092881928 - 10870 1.087 0.69445222 0.69445054 1.1797904e-07 -0.09290275 -0.09290275 -0.09290275 - 10880 1.088 0.6944896 0.6944879 7.1742582e-08 -0.092923513 -0.092923513 -0.092923513 - 10890 1.089 0.69452688 0.69452516 2.3758699e-08 -0.092944218 -0.092944218 -0.092944218 - 10900 1.09 0.69456404 0.69456232 -2.4902945e-08 -0.092964864 -0.092964864 -0.092964864 - 10910 1.091 0.69460108 0.69459938 -7.3160257e-08 -0.092985452 -0.092985452 -0.092985452 - 10920 1.092 0.69463802 0.69463633 -1.1994277e-07 -0.093005982 -0.093005982 -0.093005982 - 10930 1.093 0.69467485 0.69467319 -1.642154e-07 -0.093026454 -0.093026454 -0.093026454 - 10940 1.094 0.69471156 0.69470994 -2.0500133e-07 -0.093046868 -0.093046868 -0.093046868 - 10950 1.095 0.69474817 0.69474659 -2.4140361e-07 -0.093067225 -0.093067225 -0.093067225 - 10960 1.096 0.69478466 0.69478314 -2.7262485e-07 -0.093087524 -0.093087524 -0.093087524 - 10970 1.097 0.69482105 0.69481958 -2.9798474e-07 -0.093107766 -0.093107766 -0.093107766 - 10980 1.098 0.69485733 0.69485593 -3.1693487e-07 -0.09312795 -0.09312795 -0.09312795 - 10990 1.099 0.69489351 0.69489217 -3.2907063e-07 -0.093148078 -0.093148078 -0.093148078 - 11000 1.1 0.69492958 0.69492831 -3.3413983e-07 -0.093168148 -0.093168148 -0.093168148 - 11010 1.101 0.69496554 0.69496434 -3.3204797e-07 -0.093188162 -0.093188162 -0.093188162 - 11020 1.102 0.69500141 0.69500027 -3.2285996e-07 -0.09320812 -0.09320812 -0.09320812 - 11030 1.103 0.69503717 0.69503609 -3.0679831e-07 -0.09322802 -0.09322802 -0.09322802 - 11040 1.104 0.69507283 0.69507181 -2.8423779e-07 -0.093247865 -0.093247865 -0.093247865 - 11050 1.105 0.69510839 0.69510743 -2.5569675e-07 -0.093267653 -0.093267653 -0.093267653 - 11060 1.106 0.69514385 0.69514293 -2.2182526e-07 -0.093287386 -0.093287386 -0.093287386 - 11070 1.107 0.69517921 0.69517834 -1.8339032e-07 -0.093307062 -0.093307062 -0.093307062 - 11080 1.108 0.69521447 0.69521363 -1.4125853e-07 -0.093326683 -0.093326683 -0.093326683 - 11090 1.109 0.69524964 0.69524882 -9.6376583e-08 -0.093346248 -0.093346248 -0.093346248 - 11100 1.11 0.69528471 0.69528391 -4.9750004e-08 -0.093365758 -0.093365758 -0.093365758 - 11110 1.111 0.69531969 0.69531888 -2.4206371e-09 -0.093385213 -0.093385213 -0.093385213 - 11120 1.112 0.69535457 0.69535375 4.4556621e-08 -0.093404612 -0.093404612 -0.093404612 - 11130 1.113 0.69538935 0.69538852 9.0137329e-08 -0.093423957 -0.093423957 -0.093423957 - 11140 1.114 0.69542404 0.69542318 1.3331072e-07 -0.093443247 -0.093443247 -0.093443247 - 11150 1.115 0.69545863 0.69545774 1.7312213e-07 -0.093462482 -0.093462482 -0.093462482 - 11160 1.116 0.69549313 0.69549219 2.0869409e-07 -0.093481662 -0.093481662 -0.093481662 - 11170 1.117 0.69552753 0.69552654 2.3924572e-07 -0.093500788 -0.093500788 -0.093500788 - 11180 1.118 0.69556183 0.69556079 2.6410983e-07 -0.09351986 -0.09351986 -0.09351986 - 11190 1.119 0.69559604 0.69559493 2.8274756e-07 -0.093538877 -0.093538877 -0.093538877 - 11200 1.12 0.69563015 0.69562898 2.9476002e-07 -0.093557841 -0.093557841 -0.093557841 - 11210 1.121 0.69566416 0.69566293 2.9989688e-07 -0.093576751 -0.093576751 -0.093576751 - 11220 1.122 0.69569807 0.69569677 2.9806158e-07 -0.093595607 -0.093595607 -0.093595607 - 11230 1.123 0.69573189 0.69573053 2.8931308e-07 -0.09361441 -0.09361441 -0.09361441 - 11240 1.124 0.69576561 0.69576418 2.7386421e-07 -0.093633159 -0.093633159 -0.093633159 - 11250 1.125 0.69579923 0.69579774 2.5207657e-07 -0.093651855 -0.093651855 -0.093651855 - 11260 1.126 0.69583274 0.69583121 2.2445205e-07 -0.093670497 -0.093670497 -0.093670497 - 11270 1.127 0.69586616 0.69586458 1.9162136e-07 -0.093689087 -0.093689087 -0.093689087 - 11280 1.128 0.69589948 0.69589786 1.5432967e-07 -0.093707624 -0.093707624 -0.093707624 - 11290 1.129 0.6959327 0.69593104 1.1341969e-07 -0.093726108 -0.093726108 -0.093726108 - 11300 1.13 0.69596581 0.69596414 6.9812661e-08 -0.09374454 -0.09374454 -0.09374454 - 11310 1.131 0.69599883 0.69599714 2.4487635e-08 -0.093762919 -0.093762919 -0.093762919 - 11320 1.132 0.69603175 0.69603006 -2.1540494e-08 -0.093781246 -0.093781246 -0.093781246 - 11330 1.133 0.69606456 0.69606288 -6.7243707e-08 -0.093799521 -0.093799521 -0.093799521 - 11340 1.134 0.69609728 0.69609561 -1.1160382e-07 -0.093817744 -0.093817744 -0.093817744 - 11350 1.135 0.6961299 0.69612826 -1.5363517e-07 -0.093835915 -0.093835915 -0.093835915 - 11360 1.136 0.69616241 0.69616081 -1.9240649e-07 -0.093854034 -0.093854034 -0.093854034 - 11370 1.137 0.69619484 0.69619327 -2.2706161e-07 -0.093872101 -0.093872101 -0.093872101 - 11380 1.138 0.69622716 0.69622564 -2.5683832e-07 -0.093890118 -0.093890118 -0.093890118 - 11390 1.139 0.69625939 0.69625792 -2.8108514e-07 -0.093908082 -0.093908082 -0.093908082 - 11400 1.14 0.69629152 0.69629011 -2.9927565e-07 -0.093925996 -0.093925996 -0.093925996 - 11410 1.141 0.69632355 0.69632221 -3.1101987e-07 -0.093943859 -0.093943859 -0.093943859 - 11420 1.142 0.6963555 0.69635422 -3.1607265e-07 -0.09396167 -0.09396167 -0.09396167 - 11430 1.143 0.69638734 0.69638613 -3.143388e-07 -0.093979431 -0.093979431 -0.093979431 - 11440 1.144 0.6964191 0.69641795 -3.0587483e-07 -0.093997141 -0.093997141 -0.093997141 - 11450 1.145 0.69645077 0.69644968 -2.9088733e-07 -0.094014801 -0.094014801 -0.094014801 - 11460 1.146 0.69648235 0.69648132 -2.6972799e-07 -0.09403241 -0.09403241 -0.09403241 - 11470 1.147 0.69651384 0.69651286 -2.4288538e-07 -0.094049969 -0.094049969 -0.094049969 - 11480 1.148 0.69654524 0.6965443 -2.1097374e-07 -0.094067478 -0.094067478 -0.094067478 - 11490 1.149 0.69657655 0.69657565 -1.7471892e-07 -0.094084937 -0.094084937 -0.094084937 - 11500 1.15 0.69660777 0.69660691 -1.3494192e-07 -0.094102347 -0.094102347 -0.094102347 - 11510 1.151 0.69663891 0.69663807 -9.2540291e-08 -0.094119706 -0.094119706 -0.094119706 - 11520 1.152 0.69666997 0.69666913 -4.8467946e-08 -0.094137016 -0.094137016 -0.094137016 - 11530 1.153 0.69670094 0.6967001 -3.7136761e-09 -0.094154276 -0.094154276 -0.094154276 - 11540 1.154 0.69673182 0.69673098 4.0721009e-08 -0.094171487 -0.094171487 -0.094171487 - 11550 1.155 0.69676262 0.69676176 8.3844293e-08 -0.094188649 -0.094188649 -0.094188649 - 11560 1.156 0.69679333 0.69679245 1.2469619e-07 -0.094205762 -0.094205762 -0.094205762 - 11570 1.157 0.69682396 0.69682304 1.623699e-07 -0.094222826 -0.094222826 -0.094222826 - 11580 1.158 0.6968545 0.69685355 1.9603199e-07 -0.094239841 -0.094239841 -0.094239841 - 11590 1.159 0.69688496 0.69688396 2.2494077e-07 -0.094256808 -0.094256808 -0.094256808 - 11600 1.16 0.69691533 0.69691428 2.484627e-07 -0.094273726 -0.094273726 -0.094273726 - 11610 1.161 0.69694562 0.69694451 2.6608628e-07 -0.094290596 -0.094290596 -0.094290596 - 11620 1.162 0.69697582 0.69697465 2.7743315e-07 -0.094307417 -0.094307417 -0.094307417 - 11630 1.163 0.69700594 0.6970047 2.8226625e-07 -0.09432419 -0.09432419 -0.09432419 - 11640 1.164 0.69703596 0.69703466 2.8049475e-07 -0.094340915 -0.094340915 -0.094340915 - 11650 1.165 0.6970659 0.69706454 2.7217574e-07 -0.094357593 -0.094357593 -0.094357593 - 11660 1.166 0.69709575 0.69709433 2.5751257e-07 -0.094374222 -0.094374222 -0.094374222 - 11670 1.167 0.69712551 0.69712404 2.3684995e-07 -0.094390804 -0.094390804 -0.094390804 - 11680 1.168 0.69715518 0.69715366 2.106659e-07 -0.094407339 -0.094407339 -0.094407339 - 11690 1.169 0.69718477 0.6971832 1.7956068e-07 -0.094423826 -0.094423826 -0.094423826 - 11700 1.17 0.69721426 0.69721266 1.4424311e-07 -0.094440266 -0.094440266 -0.094440266 - 11710 1.171 0.69724367 0.69724203 1.0551442e-07 -0.094456659 -0.094456659 -0.094456659 - 11720 1.172 0.69727298 0.69727133 6.4250108e-08 -0.094473004 -0.094473004 -0.094473004 - 11730 1.173 0.69730221 0.69730054 2.1380133e-08 -0.094489303 -0.094489303 -0.094489303 - 11740 1.174 0.69733134 0.69732967 -2.2132e-08 -0.094505556 -0.094505556 -0.094505556 - 11750 1.175 0.69736039 0.69735873 -6.5310898e-08 -0.094521761 -0.094521761 -0.094521761 - 11760 1.176 0.69738934 0.6973877 -1.0719114e-07 -0.09453792 -0.09453792 -0.09453792 - 11770 1.177 0.69741821 0.69741659 -1.4683886e-07 -0.094554033 -0.094554033 -0.094554033 - 11780 1.178 0.69744699 0.6974454 -1.8337258e-07 -0.0945701 -0.0945701 -0.0945701 - 11790 1.179 0.69747568 0.69747414 -2.1598279e-07 -0.09458612 -0.09458612 -0.09458612 - 11800 1.18 0.69750429 0.69750279 -2.4394994e-07 -0.094602095 -0.094602095 -0.094602095 - 11810 1.181 0.69753281 0.69753136 -2.6666025e-07 -0.094618023 -0.094618023 -0.094618023 - 11820 1.182 0.69756125 0.69755985 -2.8361928e-07 -0.094633906 -0.094633906 -0.094633906 - 11830 1.183 0.6975896 0.69758826 -2.9446262e-07 -0.094649743 -0.094649743 -0.094649743 - 11840 1.184 0.69761786 0.69761659 -2.9896379e-07 -0.094665535 -0.094665535 -0.094665535 - 11850 1.185 0.69764605 0.69764483 -2.9703893e-07 -0.094681282 -0.094681282 -0.094681282 - 11860 1.186 0.69767415 0.697673 -2.8874832e-07 -0.094696983 -0.094696983 -0.094696983 - 11870 1.187 0.69770217 0.69770108 -2.742947e-07 -0.094712639 -0.094712639 -0.094712639 - 11880 1.188 0.69773012 0.69772907 -2.5401833e-07 -0.09472825 -0.09472825 -0.09472825 - 11890 1.189 0.69775798 0.69775698 -2.2838906e-07 -0.094743816 -0.094743816 -0.094743816 - 11900 1.19 0.69778576 0.69778481 -1.9799542e-07 -0.094759338 -0.094759338 -0.094759338 - 11910 1.191 0.69781347 0.69781255 -1.635312e-07 -0.094774815 -0.094774815 -0.094774815 - 11920 1.192 0.6978411 0.69784021 -1.257796e-07 -0.094790247 -0.094790247 -0.094790247 - 11930 1.193 0.69786866 0.69786778 -8.5595447e-08 -0.094805635 -0.094805635 -0.094805635 - 11940 1.194 0.69789613 0.69789527 -4.3885875e-08 -0.094820979 -0.094820979 -0.094820979 - 11950 1.195 0.69792354 0.69792268 -1.5898447e-09 -0.094836278 -0.094836278 -0.094836278 - 11960 1.196 0.69795086 0.69795 4.0342983e-08 -0.094851534 -0.094851534 -0.094851534 - 11970 1.197 0.69797812 0.69797723 8.097356e-08 -0.094866746 -0.094866746 -0.094866746 - 11980 1.198 0.69800529 0.69800438 1.1939448e-07 -0.094881913 -0.094881913 -0.094881913 - 11990 1.199 0.69803239 0.69803145 1.5475026e-07 -0.094897038 -0.094897038 -0.094897038 - 12000 1.2 0.69805942 0.69805844 1.8625635e-07 -0.094912118 -0.094912118 -0.094912118 - 12010 1.201 0.69808637 0.69808534 2.132166e-07 -0.094927155 -0.094927155 -0.094927155 - 12020 1.202 0.69811324 0.69811217 2.3503862e-07 -0.094942149 -0.094942149 -0.094942149 - 12030 1.203 0.69814004 0.69813891 2.512468e-07 -0.0949571 -0.0949571 -0.0949571 - 12040 1.204 0.69816676 0.69816557 2.614927e-07 -0.094972008 -0.094972008 -0.094972008 - 12050 1.205 0.6981934 0.69819216 2.6556253e-07 -0.094986872 -0.094986872 -0.094986872 - 12060 1.206 0.69821997 0.69821866 2.6338162e-07 -0.095001694 -0.095001694 -0.095001694 - 12070 1.207 0.69824646 0.69824509 2.550157e-07 -0.095016473 -0.095016473 -0.095016473 - 12080 1.208 0.69827286 0.69827145 2.4066914e-07 -0.09503121 -0.09503121 -0.09503121 - 12090 1.209 0.69829919 0.69829773 2.2067994e-07 -0.095045904 -0.095045904 -0.095045904 - 12100 1.21 0.69832545 0.69832393 1.9551185e-07 -0.095060555 -0.095060555 -0.095060555 - 12110 1.211 0.69835162 0.69835006 1.6574363e-07 -0.095075165 -0.095075165 -0.095075165 - 12120 1.212 0.69837771 0.69837612 1.3205574e-07 -0.095089732 -0.095089732 -0.095089732 - 12130 1.213 0.69840372 0.6984021 9.5214852e-08 -0.095104257 -0.095104257 -0.095104257 - 12140 1.214 0.69842965 0.69842802 5.6056405e-08 -0.09511874 -0.09511874 -0.09511874 - 12150 1.215 0.6984555 0.69845386 1.5465654e-08 -0.095133182 -0.095133182 -0.095133182 - 12160 1.216 0.69848127 0.69847963 -2.5642312e-08 -0.095147582 -0.095147582 -0.095147582 - 12170 1.217 0.69850697 0.69850533 -6.6343197e-08 -0.09516194 -0.09516194 -0.09516194 - 12180 1.218 0.69853258 0.69853096 -1.0572428e-07 -0.095176257 -0.095176257 -0.095176257 - 12190 1.219 0.69855811 0.69855651 -1.4290487e-07 -0.095190532 -0.095190532 -0.095190532 - 12200 1.22 0.69858357 0.698582 -1.7705601e-07 -0.095204766 -0.095204766 -0.095204766 - 12210 1.221 0.69860894 0.69860742 -2.0741899e-07 -0.095218959 -0.095218959 -0.095218959 - 12220 1.222 0.69863424 0.69863276 -2.3332213e-07 -0.095233111 -0.095233111 -0.095233111 - 12230 1.223 0.69865947 0.69865803 -2.5419574e-07 -0.095247223 -0.095247223 -0.095247223 - 12240 1.224 0.69868461 0.69868323 -2.6958459e-07 -0.095261293 -0.095261293 -0.095261293 - 12250 1.225 0.69870969 0.69870836 -2.7915786e-07 -0.095275323 -0.095275323 -0.095275323 - 12260 1.226 0.69873469 0.69873342 -2.8271628e-07 -0.095289312 -0.095289312 -0.095289312 - 12270 1.227 0.69875961 0.6987584 -2.8019621e-07 -0.095303261 -0.095303261 -0.095303261 - 12280 1.228 0.69878446 0.69878331 -2.716708e-07 -0.095317169 -0.095317169 -0.095317169 - 12290 1.229 0.69880924 0.69880814 -2.5734791e-07 -0.095331037 -0.095331037 -0.095331037 - 12300 1.23 0.69883396 0.6988329 -2.3756517e-07 -0.095344865 -0.095344865 -0.095344865 - 12310 1.231 0.6988586 0.69885759 -2.12782e-07 -0.095358653 -0.095358653 -0.095358653 - 12320 1.232 0.69888317 0.6988822 -1.8356899e-07 -0.095372401 -0.095372401 -0.095372401 - 12330 1.233 0.69890767 0.69890673 -1.5059482e-07 -0.09538611 -0.09538611 -0.09538611 - 12340 1.234 0.6989321 0.69893119 -1.1461091e-07 -0.095399778 -0.095399778 -0.095399778 - 12350 1.235 0.69895647 0.69895558 -7.6434352e-08 -0.095413407 -0.095413407 -0.095413407 - 12360 1.236 0.69898077 0.69897988 -3.6929391e-08 -0.095426997 -0.095426997 -0.095426997 - 12370 1.237 0.699005 0.69900412 3.0121756e-09 -0.095440547 -0.095440547 -0.095440547 - 12380 1.238 0.69902917 0.69902827 4.2491092e-08 -0.095454059 -0.095454059 -0.095454059 - 12390 1.239 0.69905327 0.69905236 8.0620895e-08 -0.095467531 -0.095467531 -0.095467531 - 12400 1.24 0.6990773 0.69907636 1.1654781e-07 -0.095480963 -0.095480963 -0.095480963 - 12410 1.241 0.69910126 0.6991003 1.4946989e-07 -0.095494357 -0.095494357 -0.095494357 - 12420 1.242 0.69912516 0.69912416 1.7865487e-07 -0.095507713 -0.095507713 -0.095507713 - 12430 1.243 0.69914899 0.69914795 2.0345652e-07 -0.095521029 -0.095521029 -0.095521029 - 12440 1.244 0.69917276 0.69917166 2.2332892e-07 -0.095534307 -0.095534307 -0.095534307 - 12450 1.245 0.69919645 0.69919531 2.3783848e-07 -0.095547546 -0.095547546 -0.095547546 - 12460 1.246 0.69922008 0.69921888 2.4667342e-07 -0.095560748 -0.095560748 -0.095560748 - 12470 1.247 0.69924364 0.69924238 2.4965047e-07 -0.09557391 -0.09557391 -0.09557391 - 12480 1.248 0.69926713 0.69926582 2.4671863e-07 -0.095587035 -0.095587035 -0.095587035 - 12490 1.249 0.69929055 0.69928918 2.3796002e-07 -0.095600121 -0.095600121 -0.095600121 - 12500 1.25 0.6993139 0.69931248 2.2358765e-07 -0.09561317 -0.09561317 -0.09561317 - 12510 1.251 0.69933718 0.69933572 2.0394029e-07 -0.095626181 -0.095626181 -0.095626181 - 12520 1.252 0.69936039 0.69935888 1.7947455e-07 -0.095639154 -0.095639154 -0.095639154 - 12530 1.253 0.69938353 0.69938198 1.5075424e-07 -0.095652089 -0.095652089 -0.095652089 - 12540 1.254 0.6994066 0.69940502 1.1843746e-07 -0.095664987 -0.095664987 -0.095664987 - 12550 1.255 0.69942959 0.69942799 8.3261482e-08 -0.095677847 -0.095677847 -0.095677847 - 12560 1.256 0.69945252 0.6994509 4.6025993e-08 -0.09569067 -0.09569067 -0.09569067 - 12570 1.257 0.69947537 0.69947375 7.5748999e-09 -0.095703456 -0.095703456 -0.095703456 - 12580 1.258 0.69949816 0.69949653 -3.1222777e-08 -0.095716205 -0.095716205 -0.095716205 - 12590 1.259 0.69952087 0.69951925 -6.9492541e-08 -0.095728916 -0.095728916 -0.095728916 - 12600 1.26 0.69954351 0.69954191 -1.0637412e-07 -0.095741591 -0.095741591 -0.095741591 - 12610 1.261 0.69956608 0.6995645 -1.4104082e-07 -0.095754229 -0.095754229 -0.095754229 - 12620 1.262 0.69958858 0.69958703 -1.7271803e-07 -0.09576683 -0.09576683 -0.09576683 - 12630 1.263 0.69961101 0.6996095 -2.0070054e-07 -0.095779394 -0.095779394 -0.095779394 - 12640 1.264 0.69963337 0.69963191 -2.2436827e-07 -0.095791923 -0.095791923 -0.095791923 - 12650 1.265 0.69965567 0.69965425 -2.4319998e-07 -0.095804414 -0.095804414 -0.095804414 - 12660 1.266 0.6996779 0.69967653 -2.5678477e-07 -0.095816869 -0.095816869 -0.095816869 - 12670 1.267 0.69970006 0.69969874 -2.6483105e-07 -0.095829289 -0.095829289 -0.095829289 - 12680 1.268 0.69972215 0.69972089 -2.6717277e-07 -0.095841672 -0.095841672 -0.095841672 - 12690 1.269 0.69974418 0.69974298 -2.6377289e-07 -0.095854019 -0.095854019 -0.095854019 - 12700 1.27 0.69976615 0.699765 -2.5472381e-07 -0.09586633 -0.09586633 -0.09586633 - 12710 1.271 0.69978805 0.69978695 -2.40245e-07 -0.095878605 -0.095878605 -0.095878605 - 12720 1.272 0.69980989 0.69980883 -2.2067767e-07 -0.095890844 -0.095890844 -0.095890844 - 12730 1.273 0.69983167 0.69983065 -1.964768e-07 -0.095903048 -0.095903048 -0.095903048 - 12740 1.274 0.69985339 0.69985241 -1.682006e-07 -0.095915217 -0.095915217 -0.095915217 - 12750 1.275 0.69987504 0.69987409 -1.3649759e-07 -0.09592735 -0.09592735 -0.09592735 - 12760 1.276 0.69989664 0.69989571 -1.0209182e-07 -0.095939448 -0.095939448 -0.095939448 - 12770 1.277 0.69991818 0.69991726 -6.5766278e-08 -0.09595151 -0.09595151 -0.09595151 - 12780 1.278 0.69993965 0.69993874 -2.8345147e-08 -0.095963537 -0.095963537 -0.095963537 - 12790 1.279 0.69996107 0.69996016 9.3249255e-09 -0.09597553 -0.09597553 -0.09597553 - 12800 1.28 0.69998243 0.69998151 4.6393961e-08 -0.095987487 -0.095987487 -0.095987487 - 12810 1.281 0.70000373 0.70000279 8.2027829e-08 -0.09599941 -0.09599941 -0.09599941 - 12820 1.282 0.70002497 0.70002401 1.1542701e-07 -0.096011298 -0.096011298 -0.096011298 - 12830 1.283 0.70004615 0.70004516 1.4584454e-07 -0.096023151 -0.096023151 -0.096023151 - 12840 1.284 0.70006727 0.70006624 1.7260271e-07 -0.09603497 -0.09603497 -0.09603497 - 12850 1.285 0.70008834 0.70008727 1.9510818e-07 -0.096046754 -0.096046754 -0.096046754 - 12860 1.286 0.70010934 0.70010822 2.1286511e-07 -0.096058504 -0.096058504 -0.096058504 - 12870 1.287 0.70013028 0.70012911 2.2548613e-07 -0.09607022 -0.09607022 -0.09607022 - 12880 1.288 0.70015116 0.70014995 2.3270076e-07 -0.096081901 -0.096081901 -0.096081901 - 12890 1.289 0.70017198 0.70017071 2.343612e-07 -0.096093549 -0.096093549 -0.096093549 - 12900 1.29 0.70019274 0.70019142 2.3044536e-07 -0.096105162 -0.096105162 -0.096105162 - 12910 1.291 0.70021344 0.70021207 2.21057e-07 -0.096116742 -0.096116742 -0.096116742 - 12920 1.292 0.70023408 0.70023266 2.064231e-07 -0.096128288 -0.096128288 -0.096128288 - 12930 1.293 0.70025465 0.70025318 1.8688835e-07 -0.0961398 -0.0961398 -0.0961398 - 12940 1.294 0.70027516 0.70027366 1.6290711e-07 -0.096151279 -0.096151279 -0.096151279 - 12950 1.295 0.70029561 0.70029407 1.3503284e-07 -0.096162724 -0.096162724 -0.096162724 - 12960 1.296 0.70031599 0.70031442 1.0390534e-07 -0.096174135 -0.096174135 -0.096174135 - 12970 1.297 0.70033631 0.70033472 7.0236124e-08 -0.096185514 -0.096185514 -0.096185514 - 12980 1.298 0.70035657 0.70035497 3.4792111e-08 -0.096196859 -0.096196859 -0.096196859 - 12990 1.299 0.70037676 0.70037515 -1.621789e-09 -0.096208171 -0.096208171 -0.096208171 - 13000 1.3 0.70039689 0.70039529 -3.8180966e-08 -0.09621945 -0.09621945 -0.09621945 - 13010 1.301 0.70041696 0.70041536 -7.405977e-08 -0.096230697 -0.096230697 -0.096230697 - 13020 1.302 0.70043696 0.70043538 -1.0845016e-07 -0.09624191 -0.09624191 -0.09624191 - 13030 1.303 0.7004569 0.70045535 -1.4057989e-07 -0.096253091 -0.096253091 -0.096253091 - 13040 1.304 0.70047678 0.70047526 -1.6972986e-07 -0.096264239 -0.096264239 -0.096264239 - 13050 1.305 0.7004966 0.70049511 -1.952502e-07 -0.096275354 -0.096275354 -0.096275354 - 13060 1.306 0.70051635 0.70051491 -2.1657479e-07 -0.096286437 -0.096286437 -0.096286437 - 13070 1.307 0.70053605 0.70053465 -2.3323376e-07 -0.096297487 -0.096297487 -0.096297487 - 13080 1.308 0.70055569 0.70055434 -2.4486392e-07 -0.096308506 -0.096308506 -0.096308506 - 13090 1.309 0.70057526 0.70057396 -2.5121661e-07 -0.096319492 -0.096319492 -0.096319492 - 13100 1.31 0.70059478 0.70059353 -2.5216307e-07 -0.096330446 -0.096330446 -0.096330446 - 13110 1.311 0.70061425 0.70061305 -2.4769696e-07 -0.096341368 -0.096341368 -0.096341368 - 13120 1.312 0.70063365 0.7006325 -2.3793426e-07 -0.096352258 -0.096352258 -0.096352258 - 13130 1.313 0.700653 0.7006519 -2.2311023e-07 -0.096363116 -0.096363116 -0.096363116 - 13140 1.314 0.70067229 0.70067123 -2.0357386e-07 -0.096373942 -0.096373942 -0.096373942 - 13150 1.315 0.70069153 0.70069051 -1.7977963e-07 -0.096384737 -0.096384737 -0.096384737 - 13160 1.316 0.70071072 0.70070973 -1.5227697e-07 -0.0963955 -0.0963955 -0.0963955 - 13170 1.317 0.70072985 0.70072888 -1.2169761e-07 -0.096406232 -0.096406232 -0.096406232 - 13180 1.318 0.70074893 0.70074798 -8.8741043e-08 -0.096416932 -0.096416932 -0.096416932 - 13190 1.319 0.70076795 0.70076702 -5.4158599e-08 -0.096427601 -0.096427601 -0.096427601 - 13200 1.32 0.70078693 0.700786 -1.873627e-08 -0.096438239 -0.096438239 -0.096438239 - 13210 1.321 0.70080585 0.70080492 1.6723116e-08 -0.096448846 -0.096448846 -0.096448846 - 13220 1.322 0.70082472 0.70082377 5.1418091e-08 -0.096459421 -0.096459421 -0.096459421 - 13230 1.323 0.70084353 0.70084257 8.4566661e-08 -0.096469966 -0.096469966 -0.096469966 - 13240 1.324 0.7008623 0.70086131 1.1542392e-07 -0.09648048 -0.09648048 -0.09648048 - 13250 1.325 0.70088101 0.70087999 1.4329881e-07 -0.096490963 -0.096490963 -0.096490963 - 13260 1.326 0.70089967 0.70089862 1.6756957e-07 -0.096501415 -0.096501415 -0.096501415 - 13270 1.327 0.70091828 0.70091718 1.8769761e-07 -0.096511837 -0.096511837 -0.096511837 - 13280 1.328 0.70093683 0.70093569 2.032395e-07 -0.096522228 -0.096522228 -0.096522228 - 13290 1.329 0.70095533 0.70095415 2.1385668e-07 -0.096532589 -0.096532589 -0.096532589 - 13300 1.33 0.70097378 0.70097254 2.1932289e-07 -0.09654292 -0.09654292 -0.09654292 - 13310 1.331 0.70099217 0.70099089 2.1952893e-07 -0.09655322 -0.09655322 -0.09655322 - 13320 1.332 0.70101051 0.70100918 2.1448487e-07 -0.09656349 -0.09656349 -0.09656349 - 13330 1.333 0.70102879 0.70102741 2.0431946e-07 -0.09657373 -0.09657373 -0.09657373 - 13340 1.334 0.70104702 0.7010456 1.8927691e-07 -0.09658394 -0.09658394 -0.09658394 - 13350 1.335 0.70106519 0.70106373 1.6971105e-07 -0.09659412 -0.09659412 -0.09659412 - 13360 1.336 0.70108331 0.70108181 1.4607705e-07 -0.09660427 -0.09660427 -0.09660427 - 13370 1.337 0.70110137 0.70109984 1.1892082e-07 -0.096614391 -0.096614391 -0.096614391 - 13380 1.338 0.70111937 0.70111782 8.8866473e-08 -0.096624481 -0.096624481 -0.096624481 - 13390 1.339 0.70113732 0.70113574 5.6601919e-08 -0.096634542 -0.096634542 -0.096634542 - 13400 1.34 0.70115521 0.70115362 2.2863193e-08 -0.096644574 -0.096644574 -0.096644574 - 13410 1.341 0.70117304 0.70117145 -1.1582356e-08 -0.096654576 -0.096654576 -0.096654576 - 13420 1.342 0.70119082 0.70118924 -4.5953497e-08 -0.096664549 -0.096664549 -0.096664549 - 13430 1.343 0.70120854 0.70120697 -7.947284e-08 -0.096674493 -0.096674493 -0.096674493 - 13440 1.344 0.70122621 0.70122465 -1.1138441e-07 -0.096684408 -0.096684408 -0.096684408 - 13450 1.345 0.70124382 0.70124229 -1.4097069e-07 -0.096694293 -0.096694293 -0.096694293 - 13460 1.346 0.70126137 0.70125987 -1.6756876e-07 -0.096704149 -0.096704149 -0.096704149 - 13470 1.347 0.70127887 0.70127741 -1.9058516e-07 -0.096713977 -0.096713977 -0.096713977 - 13480 1.348 0.70129632 0.70129489 -2.095091e-07 -0.096723776 -0.096723776 -0.096723776 - 13490 1.349 0.70131371 0.70131233 -2.2392384e-07 -0.096733546 -0.096733546 -0.096733546 - 13500 1.35 0.70133105 0.70132971 -2.3351583e-07 -0.096743287 -0.096743287 -0.096743287 - 13510 1.351 0.70134834 0.70134705 -2.3808155e-07 -0.096752999 -0.096752999 -0.096752999 - 13520 1.352 0.70136557 0.70136433 -2.3753179e-07 -0.096762684 -0.096762684 -0.096762684 - 13530 1.353 0.70138276 0.70138157 -2.318934e-07 -0.096772339 -0.096772339 -0.096772339 - 13540 1.354 0.70139989 0.70139875 -2.2130834e-07 -0.096781967 -0.096781967 -0.096781967 - 13550 1.355 0.70141698 0.70141588 -2.0603016e-07 -0.096791566 -0.096791566 -0.096791566 - 13560 1.356 0.70143402 0.70143295 -1.8641795e-07 -0.096801137 -0.096801137 -0.096801137 - 13570 1.357 0.701451 0.70144997 -1.6292792e-07 -0.096810679 -0.096810679 -0.096810679 - 13580 1.358 0.70146795 0.70146695 -1.3610284e-07 -0.096820194 -0.096820194 -0.096820194 - 13590 1.359 0.70148484 0.70148386 -1.0655946e-07 -0.096829681 -0.096829681 -0.096829681 - 13600 1.36 0.70150169 0.70150073 -7.4974411e-08 -0.09683914 -0.09683914 -0.09683914 - 13610 1.361 0.70151849 0.70151754 -4.2068642e-08 -0.096848571 -0.096848571 -0.096848571 - 13620 1.362 0.70153524 0.70153429 -8.5910346e-09 -0.096857974 -0.096857974 -0.096857974 - 13630 1.363 0.70155195 0.701551 2.4698661e-08 -0.09686735 -0.09686735 -0.09686735 - 13640 1.364 0.70156861 0.70156765 5.7047056e-08 -0.096876699 -0.096876699 -0.096876699 - 13650 1.365 0.70158523 0.70158424 8.7724172e-08 -0.096886019 -0.096886019 -0.096886019 - 13660 1.366 0.7016018 0.70160079 1.1603991e-07 -0.096895313 -0.096895313 -0.096895313 - 13670 1.367 0.70161833 0.70161728 1.4135956e-07 -0.096904579 -0.096904579 -0.096904579 - 13680 1.368 0.7016348 0.70163373 1.6311807e-07 -0.096913817 -0.096913817 -0.096913817 - 13690 1.369 0.70165123 0.70165012 1.808326e-07 -0.096923029 -0.096923029 -0.096923029 - 13700 1.37 0.70166762 0.70166646 1.9411326e-07 -0.096932214 -0.096932214 -0.096932214 - 13710 1.371 0.70168396 0.70168275 2.0267172e-07 -0.096941371 -0.096941371 -0.096941371 - 13720 1.372 0.70170024 0.70169899 2.0632742e-07 -0.096950502 -0.096950502 -0.096950502 - 13730 1.373 0.70171648 0.70171519 2.0501137e-07 -0.096959606 -0.096959606 -0.096959606 - 13740 1.374 0.70173268 0.70173133 1.9876745e-07 -0.096968682 -0.096968682 -0.096968682 - 13750 1.375 0.70174882 0.70174743 1.8775106e-07 -0.096977733 -0.096977733 -0.096977733 - 13760 1.376 0.70176491 0.70176349 1.7222531e-07 -0.096986756 -0.096986756 -0.096986756 - 13770 1.377 0.70178096 0.70177949 1.5255477e-07 -0.096995753 -0.096995753 -0.096995753 - 13780 1.378 0.70179695 0.70179546 1.2919695e-07 -0.097004724 -0.097004724 -0.097004724 - 13790 1.379 0.7018129 0.70181137 1.026916e-07 -0.097013668 -0.097013668 -0.097013668 - 13800 1.38 0.70182879 0.70182725 7.3648346e-08 -0.097022586 -0.097022586 -0.097022586 - 13810 1.381 0.70184464 0.70184308 4.273262e-08 -0.097031478 -0.097031478 -0.097031478 - 13820 1.382 0.70186043 0.70185886 1.0650445e-08 -0.097040343 -0.097040343 -0.097040343 - 13830 1.383 0.70187617 0.7018746 -2.1867685e-08 -0.097049182 -0.097049182 -0.097049182 - 13840 1.384 0.70189187 0.7018903 -5.4083428e-08 -0.097057996 -0.097057996 -0.097057996 - 13850 1.385 0.70190751 0.70190596 -8.5267357e-08 -0.097066783 -0.097066783 -0.097066783 - 13860 1.386 0.7019231 0.70192157 -1.1471547e-07 -0.097075545 -0.097075545 -0.097075545 - 13870 1.387 0.70193865 0.70193714 -1.4176509e-07 -0.09708428 -0.09708428 -0.09708428 - 13880 1.388 0.70195414 0.70195267 -1.6580975e-07 -0.09709299 -0.09709299 -0.09709299 - 13890 1.389 0.70196959 0.70196815 -1.8631284e-07 -0.097101674 -0.097101674 -0.097101674 - 13900 1.39 0.70198499 0.70198359 -2.028195e-07 -0.097110333 -0.097110333 -0.097110333 - 13910 1.391 0.70200034 0.70199898 -2.1496682e-07 -0.097118966 -0.097118966 -0.097118966 - 13920 1.392 0.70201565 0.70201433 -2.2249171e-07 -0.097127574 -0.097127574 -0.097127574 - 13930 1.393 0.70203091 0.70202964 -2.2523667e-07 -0.097136156 -0.097136156 -0.097136156 - 13940 1.394 0.70204612 0.70204489 -2.2315301e-07 -0.097144713 -0.097144713 -0.097144713 - 13950 1.395 0.70206129 0.70206011 -2.1630171e-07 -0.097153245 -0.097153245 -0.097153245 - 13960 1.396 0.70207642 0.70207528 -2.048517e-07 -0.097161752 -0.097161752 -0.097161752 - 13970 1.397 0.7020915 0.7020904 -1.8907575e-07 -0.097170234 -0.097170234 -0.097170234 - 13980 1.398 0.70210654 0.70210547 -1.6934396e-07 -0.09717869 -0.09717869 -0.09717869 - 13990 1.399 0.70212153 0.7021205 -1.4611516e-07 -0.097187122 -0.097187122 -0.097187122 - 14000 1.4 0.70213649 0.70213548 -1.199262e-07 -0.097195529 -0.097195529 -0.097195529 - 14010 1.401 0.7021514 0.70215041 -9.1379589e-08 -0.097203911 -0.097203911 -0.097203911 - 14020 1.402 0.70216627 0.70216529 -6.1129618e-08 -0.097212268 -0.097212268 -0.097212268 - 14030 1.403 0.7021811 0.70218013 -2.9867402e-08 -0.097220601 -0.097220601 -0.097220601 - 14040 1.404 0.70219589 0.70219492 1.6949188e-09 -0.097228909 -0.097228909 -0.097228909 - 14050 1.405 0.70221064 0.70220966 3.2840391e-08 -0.097237192 -0.097237192 -0.097237192 - 14060 1.406 0.70222535 0.70222436 6.2863529e-08 -0.097245452 -0.097245452 -0.097245452 - 14070 1.407 0.70224002 0.70223901 9.1086294e-08 -0.097253686 -0.097253686 -0.097253686 - 14080 1.408 0.70225465 0.70225361 1.168734e-07 -0.097261897 -0.097261897 -0.097261897 - 14090 1.409 0.70226923 0.70226817 1.3964662e-07 -0.097270083 -0.097270083 -0.097270083 - 14100 1.41 0.70228378 0.70228268 1.5889773e-07 -0.097278245 -0.097278245 -0.097278245 - 14110 1.411 0.70229828 0.70229714 1.7419988e-07 -0.097286383 -0.097286383 -0.097286383 - 14120 1.412 0.70231275 0.70231157 1.8521704e-07 -0.097294497 -0.097294497 -0.097294497 - 14130 1.413 0.70232717 0.70232594 1.9171137e-07 -0.097302587 -0.097302587 -0.097302587 - 14140 1.414 0.70234155 0.70234028 1.9354835e-07 -0.097310653 -0.097310653 -0.097310653 - 14150 1.415 0.70235588 0.70235457 1.9069957e-07 -0.097318695 -0.097318695 -0.097318695 - 14160 1.416 0.70237017 0.70236882 1.8324303e-07 -0.097326714 -0.097326714 -0.097326714 - 14170 1.417 0.70238442 0.70238303 1.7136113e-07 -0.097334709 -0.097334709 -0.097334709 - 14180 1.418 0.70239863 0.70239719 1.5533621e-07 -0.09734268 -0.09734268 -0.09734268 - 14190 1.419 0.70241279 0.70241132 1.3554388e-07 -0.097350628 -0.097350628 -0.097350628 - 14200 1.42 0.7024269 0.70242541 1.1244419e-07 -0.097358552 -0.097358552 -0.097358552 - 14210 1.421 0.70244098 0.70243946 8.657102e-08 -0.097366453 -0.097366453 -0.097366453 - 14220 1.422 0.702455 0.70245347 5.8519701e-08 -0.097374331 -0.097374331 -0.097374331 - 14230 1.423 0.70246899 0.70246744 2.8933347e-08 -0.097382185 -0.097382185 -0.097382185 - 14240 1.424 0.70248292 0.70248137 -1.5118877e-09 -0.097390016 -0.097390016 -0.097390016 - 14250 1.425 0.70249682 0.70249526 -3.2122246e-08 -0.097397824 -0.097397824 -0.097397824 - 14260 1.426 0.70251067 0.70250912 -6.2202178e-08 -0.097405609 -0.097405609 -0.097405609 - 14270 1.427 0.70252447 0.70252294 -9.1070138e-08 -0.09741337 -0.09741337 -0.09741337 - 14280 1.428 0.70253823 0.70253672 -1.1807402e-07 -0.097421109 -0.097421109 -0.097421109 - 14290 1.429 0.70255195 0.70255046 -1.4260591e-07 -0.097428825 -0.097428825 -0.097428825 - 14300 1.43 0.70256562 0.70256416 -1.6411572e-07 -0.097436518 -0.097436518 -0.097436518 - 14310 1.431 0.70257925 0.70257783 -1.8212358e-07 -0.097444189 -0.097444189 -0.097444189 - 14320 1.432 0.70259284 0.70259145 -1.9623049e-07 -0.097451837 -0.097451837 -0.097451837 - 14330 1.433 0.70260638 0.70260504 -2.061272e-07 -0.097459462 -0.097459462 -0.097459462 - 14340 1.434 0.70261989 0.70261859 -2.1160096e-07 -0.097467064 -0.097467064 -0.097467064 - 14350 1.435 0.70263335 0.7026321 -2.1254009e-07 -0.097474645 -0.097474645 -0.097474645 - 14360 1.436 0.70264678 0.70264556 -2.0893625e-07 -0.097482202 -0.097482202 -0.097482202 - 14370 1.437 0.70266016 0.70265899 -2.0088431e-07 -0.097489738 -0.097489738 -0.097489738 - 14380 1.438 0.70267351 0.70267237 -1.8857993e-07 -0.097497251 -0.097497251 -0.097497251 - 14390 1.439 0.70268682 0.70268572 -1.7231485e-07 -0.097504742 -0.097504742 -0.097504742 - 14400 1.44 0.70270009 0.70269902 -1.5246993e-07 -0.09751221 -0.09751221 -0.09751221 - 14410 1.441 0.70271332 0.70271228 -1.2950634e-07 -0.097519657 -0.097519657 -0.097519657 - 14420 1.442 0.70272652 0.7027255 -1.0395477e-07 -0.097527081 -0.097527081 -0.097527081 - 14430 1.443 0.70273968 0.70273867 -7.6403244e-08 -0.097534484 -0.097534484 -0.097534484 - 14440 1.444 0.7027528 0.70275181 -4.7483544e-08 -0.097541865 -0.097541865 -0.097541865 - 14450 1.445 0.70276589 0.7027649 -1.7856769e-08 -0.097549223 -0.097549223 -0.097549223 - 14460 1.446 0.70277894 0.70277795 1.1801786e-08 -0.097556561 -0.097556561 -0.097556561 - 14470 1.447 0.70279195 0.70279095 4.0818017e-08 -0.097563876 -0.097563876 -0.097563876 - 14480 1.448 0.70280493 0.70280392 6.8534325e-08 -0.09757117 -0.09757117 -0.09757117 - 14490 1.449 0.70281788 0.70281684 9.4324517e-08 -0.097578442 -0.097578442 -0.097578442 - 14500 1.45 0.70283079 0.70282973 1.1760795e-07 -0.097585692 -0.097585692 -0.097585692 - 14510 1.451 0.70284366 0.70284257 1.3786261e-07 -0.097592921 -0.097592921 -0.097592921 - 14520 1.452 0.7028565 0.70285537 1.546368e-07 -0.097600129 -0.097600129 -0.097600129 - 14530 1.453 0.7028693 0.70286813 1.6755921e-07 -0.097607315 -0.097607315 -0.097607315 - 14540 1.454 0.70288206 0.70288086 1.7634715e-07 -0.09761448 -0.09761448 -0.09761448 - 14550 1.455 0.70289478 0.70289354 1.8081273e-07 -0.097621624 -0.097621624 -0.097621624 - 14560 1.456 0.70290747 0.70290619 1.8086683e-07 -0.097628747 -0.097628747 -0.097628747 - 14570 1.457 0.70292012 0.70291879 1.7652089e-07 -0.097635848 -0.097635848 -0.097635848 - 14580 1.458 0.70293273 0.70293137 1.6788635e-07 -0.097642929 -0.097642929 -0.097642929 - 14590 1.459 0.7029453 0.7029439 1.5517184e-07 -0.097649989 -0.097649989 -0.097649989 - 14600 1.46 0.70295784 0.7029564 1.3867815e-07 -0.097657027 -0.097657027 -0.097657027 - 14610 1.461 0.70297033 0.70296887 1.1879117e-07 -0.097664045 -0.097664045 -0.097664045 - 14620 1.462 0.70298279 0.7029813 9.5972821e-08 -0.097671042 -0.097671042 -0.097671042 - 14630 1.463 0.7029952 0.70299369 7.0750397e-08 -0.097678018 -0.097678018 -0.097678018 - 14640 1.464 0.70300758 0.70300605 4.3704347e-08 -0.097684974 -0.097684974 -0.097684974 - 14650 1.465 0.70301991 0.70301838 1.5454946e-08 -0.097691909 -0.097691909 -0.097691909 - 14660 1.466 0.70303221 0.70303067 -1.3351931e-08 -0.097698823 -0.097698823 -0.097698823 - 14670 1.467 0.70304446 0.70304293 -4.2059562e-08 -0.097705717 -0.097705717 -0.097705717 - 14680 1.468 0.70305668 0.70305516 -7.0015352e-08 -0.097712591 -0.097712591 -0.097712591 - 14690 1.469 0.70306886 0.70306735 -9.658566e-08 -0.097719444 -0.097719444 -0.097719444 - 14700 1.47 0.703081 0.70307951 -1.2117016e-07 -0.097726277 -0.097726277 -0.097726277 - 14710 1.471 0.7030931 0.70309163 -1.432154e-07 -0.097733089 -0.097733089 -0.097733089 - 14720 1.472 0.70310516 0.70310372 -1.6222726e-07 -0.097739882 -0.097739882 -0.097739882 - 14730 1.473 0.70311718 0.70311578 -1.7778203e-07 -0.097746654 -0.097746654 -0.097746654 - 14740 1.474 0.70312916 0.7031278 -1.8953585e-07 -0.097753406 -0.097753406 -0.097753406 - 14750 1.475 0.70314111 0.70313979 -1.9723228e-07 -0.097760138 -0.097760138 -0.097760138 - 14760 1.476 0.70315303 0.70315174 -2.0070795e-07 -0.09776685 -0.09776685 -0.09776685 - 14770 1.477 0.7031649 0.70316366 -1.9989595e-07 -0.097773542 -0.097773542 -0.097773542 - 14780 1.478 0.70317675 0.70317554 -1.9482712e-07 -0.097780215 -0.097780215 -0.097780215 - 14790 1.479 0.70318855 0.70318739 -1.8562905e-07 -0.097786867 -0.097786867 -0.097786867 - 14800 1.48 0.70320033 0.7031992 -1.7252294e-07 -0.0977935 -0.0977935 -0.0977935 - 14810 1.481 0.70321206 0.70321097 -1.5581824e-07 -0.097800113 -0.097800113 -0.097800113 - 14820 1.482 0.70322377 0.7032227 -1.3590543e-07 -0.097806707 -0.097806707 -0.097806707 - 14830 1.483 0.70323545 0.7032344 -1.1324688e-07 -0.097813281 -0.097813281 -0.097813281 - 14840 1.484 0.70324709 0.70324606 -8.8366093e-08 -0.097819835 -0.097819835 -0.097819835 - 14850 1.485 0.7032587 0.70325768 -6.1835671e-08 -0.09782637 -0.09782637 -0.09782637 - 14860 1.486 0.70327027 0.70326927 -3.4264114e-08 -0.097832886 -0.097832886 -0.097832886 - 14870 1.487 0.70328182 0.70328081 -6.2818816e-09 -0.097839382 -0.097839382 -0.097839382 - 14880 1.488 0.70329333 0.70329232 2.1473021e-08 -0.097845859 -0.097845859 -0.097845859 - 14890 1.489 0.70330482 0.7033038 4.8369582e-08 -0.097852317 -0.097852317 -0.097852317 - 14900 1.49 0.70331627 0.70331523 7.3798129e-08 -0.097858755 -0.097858755 -0.097858755 - 14910 1.491 0.70332769 0.70332663 9.718414e-08 -0.097865175 -0.097865175 -0.097865175 - 14920 1.492 0.70333908 0.70333799 1.1800123e-07 -0.097871575 -0.097871575 -0.097871575 - 14930 1.493 0.70335043 0.70334932 1.3578298e-07 -0.097877956 -0.097877956 -0.097877956 - 14940 1.494 0.70336176 0.70336061 1.501334e-07 -0.097884319 -0.097884319 -0.097884319 - 14950 1.495 0.70337305 0.70337187 1.6073576e-07 -0.097890662 -0.097890662 -0.097890662 - 14960 1.496 0.70338431 0.70338309 1.6735952e-07 -0.097896987 -0.097896987 -0.097896987 - 14970 1.497 0.70339554 0.70339427 1.6986541e-07 -0.097903293 -0.097903293 -0.097903293 - 14980 1.498 0.70340673 0.70340543 1.6820826e-07 -0.09790958 -0.09790958 -0.09790958 - 14990 1.499 0.70341789 0.70341655 1.6243785e-07 -0.097915849 -0.097915849 -0.097915849 - 15000 1.5 0.70342901 0.70342764 1.5269743e-07 -0.097922098 -0.097922098 -0.097922098 - 15010 1.501 0.7034401 0.70343869 1.3922024e-07 -0.09792833 -0.09792833 -0.09792833 - 15020 1.502 0.70345116 0.70344972 1.2232395e-07 -0.097934543 -0.097934543 -0.097934543 - 15030 1.503 0.70346218 0.70346071 1.0240314e-07 -0.097940737 -0.097940737 -0.097940737 - 15040 1.504 0.70347316 0.70347168 7.9920151e-08 -0.097946913 -0.097946913 -0.097946913 - 15050 1.505 0.70348411 0.70348261 5.5394328e-08 -0.09795307 -0.09795307 -0.09795307 - 15060 1.506 0.70349503 0.70349351 2.9390054e-08 -0.09795921 -0.09795921 -0.09795921 - 15070 1.507 0.70350591 0.70350438 2.5037625e-09 -0.097965331 -0.097965331 -0.097965331 - 15080 1.508 0.70351675 0.70351523 -2.4649737e-08 -0.097971434 -0.097971434 -0.097971434 - 15090 1.509 0.70352756 0.70352604 -5.145131e-08 -0.097977518 -0.097977518 -0.097977518 - 15100 1.51 0.70353833 0.70353683 -7.7291613e-08 -0.097983585 -0.097983585 -0.097983585 - 15110 1.511 0.70354907 0.70354758 -1.0158494e-07 -0.097989633 -0.097989633 -0.097989633 - 15120 1.512 0.70355978 0.70355831 -1.2378249e-07 -0.097995664 -0.097995664 -0.097995664 - 15130 1.513 0.70357044 0.703569 -1.4338479e-07 -0.098001677 -0.098001677 -0.098001677 - 15140 1.514 0.70358108 0.70357967 -1.5995288e-07 -0.098007671 -0.098007671 -0.098007671 - 15150 1.515 0.70359168 0.70359031 -1.731182e-07 -0.098013648 -0.098013648 -0.098013648 - 15160 1.516 0.70360225 0.70360091 -1.8259073e-07 -0.098019608 -0.098019608 -0.098019608 - 15170 1.517 0.70361279 0.70361149 -1.8816541e-07 -0.098025549 -0.098025549 -0.098025549 - 15180 1.518 0.7036233 0.70362203 -1.8972657e-07 -0.098031473 -0.098031473 -0.098031473 - 15190 1.519 0.70363377 0.70363254 -1.8725029e-07 -0.098037379 -0.098037379 -0.098037379 - 15200 1.52 0.70364421 0.70364302 -1.8080468e-07 -0.098043268 -0.098043268 -0.098043268 - 15210 1.521 0.70365462 0.70365347 -1.7054811e-07 -0.098049139 -0.098049139 -0.098049139 - 15220 1.522 0.70366501 0.70366388 -1.567253e-07 -0.098054992 -0.098054992 -0.098054992 - 15230 1.523 0.70367536 0.70367426 -1.3966151e-07 -0.098060828 -0.098060828 -0.098060828 - 15240 1.524 0.70368568 0.70368461 -1.1975493e-07 -0.098066647 -0.098066647 -0.098066647 - 15250 1.525 0.70369598 0.70369493 -9.7467355e-08 -0.098072449 -0.098072449 -0.098072449 - 15260 1.526 0.70370625 0.70370521 -7.3313509e-08 -0.098078233 -0.098078233 -0.098078233 - 15270 1.527 0.70371649 0.70371546 -4.7849162e-08 -0.098084 -0.098084 -0.098084 - 15280 1.528 0.7037267 0.70372568 -2.1658348e-08 -0.09808975 -0.09808975 -0.09808975 - 15290 1.529 0.70373688 0.70373586 4.6600242e-09 -0.098095483 -0.098095483 -0.098095483 - 15300 1.53 0.70374704 0.70374601 3.0505861e-08 -0.098101199 -0.098101199 -0.098101199 - 15310 1.531 0.70375717 0.70375612 5.5291564e-08 -0.098106897 -0.098106897 -0.098106897 - 15320 1.532 0.70376727 0.70376621 7.8455383e-08 -0.098112579 -0.098112579 -0.098112579 - 15330 1.533 0.70377734 0.70377626 9.9474145e-08 -0.098118244 -0.098118244 -0.098118244 - 15340 1.534 0.70378739 0.70378628 1.1787507e-07 -0.098123892 -0.098123892 -0.098123892 - 15350 1.535 0.7037974 0.70379626 1.3324639e-07 -0.098129523 -0.098129523 -0.098129523 - 15360 1.536 0.70380739 0.70380622 1.452466e-07 -0.098135137 -0.098135137 -0.098135137 - 15370 1.537 0.70381735 0.70381614 1.5361197e-07 -0.098140735 -0.098140735 -0.098140735 - 15380 1.538 0.70382728 0.70382604 1.581624e-07 -0.098146316 -0.098146316 -0.098146316 - 15390 1.539 0.70383718 0.7038359 1.5880528e-07 -0.09815188 -0.09815188 -0.09815188 - 15400 1.54 0.70384705 0.70384574 1.555373e-07 -0.098157428 -0.098157428 -0.098157428 - 15410 1.541 0.70385689 0.70385554 1.4844432e-07 -0.098162959 -0.098162959 -0.098162959 - 15420 1.542 0.7038667 0.70386532 1.3769916e-07 -0.098168474 -0.098168474 -0.098168474 - 15430 1.543 0.70387648 0.70387507 1.2355736e-07 -0.098173973 -0.098173973 -0.098173973 - 15440 1.544 0.70388623 0.70388479 1.0635119e-07 -0.098179455 -0.098179455 -0.098179455 - 15450 1.545 0.70389595 0.70389449 8.6481803e-08 -0.09818492 -0.09818492 -0.09818492 - 15460 1.546 0.70390564 0.70390415 6.4409912e-08 -0.09819037 -0.09819037 -0.09819037 - 15470 1.547 0.70391529 0.7039138 4.0645117e-08 -0.098195803 -0.098195803 -0.098195803 - 15480 1.548 0.70392492 0.70392341 1.5734144e-08 -0.09820122 -0.09820122 -0.09820122 - 15490 1.549 0.70393451 0.703933 -9.7517264e-09 -0.098206621 -0.098206621 -0.098206621 - 15500 1.55 0.70394407 0.70394256 -3.5229752e-08 -0.098212005 -0.098212005 -0.098212005 - 15510 1.551 0.7039536 0.7039521 -6.0119051e-08 -0.098217374 -0.098217374 -0.098217374 - 15520 1.552 0.7039631 0.70396161 -8.3853843e-08 -0.098222727 -0.098222727 -0.098222727 - 15530 1.553 0.70397256 0.7039711 -1.058963e-07 -0.098228064 -0.098228064 -0.098228064 - 15540 1.554 0.703982 0.70398056 -1.2574875e-07 -0.098233384 -0.098233384 -0.098233384 - 15550 1.555 0.70399141 0.70398999 -1.4296488e-07 -0.098238689 -0.098238689 -0.098238689 - 15560 1.556 0.70400079 0.7039994 -1.5715979e-07 -0.098243979 -0.098243979 -0.098243979 - 15570 1.557 0.70401013 0.70400878 -1.6801858e-07 -0.098249252 -0.098249252 -0.098249252 - 15580 1.558 0.70401945 0.70401813 -1.7530336e-07 -0.09825451 -0.09825451 -0.09825451 - 15590 1.559 0.70402874 0.70402745 -1.7885842e-07 -0.098259752 -0.098259752 -0.098259752 - 15600 1.56 0.704038 0.70403675 -1.7861355e-07 -0.098264978 -0.098264978 -0.098264978 - 15610 1.561 0.70404724 0.70404602 -1.7458543e-07 -0.098270189 -0.098270189 -0.098270189 - 15620 1.562 0.70405644 0.70405526 -1.6687696e-07 -0.098275384 -0.098275384 -0.098275384 - 15630 1.563 0.70406562 0.70406447 -1.5567469e-07 -0.098280564 -0.098280564 -0.098280564 - 15640 1.564 0.70407478 0.70407366 -1.4124432e-07 -0.098285728 -0.098285728 -0.098285728 - 15650 1.565 0.70408391 0.70408281 -1.2392441e-07 -0.098290877 -0.098290877 -0.098290877 - 15660 1.566 0.70409301 0.70409194 -1.0411845e-07 -0.098296011 -0.098296011 -0.098296011 - 15670 1.567 0.70410209 0.70410103 -8.228546e-08 -0.098301129 -0.098301129 -0.098301129 - 15680 1.568 0.70411114 0.7041101 -5.8929393e-08 -0.098306232 -0.098306232 -0.098306232 - 15690 1.569 0.70412017 0.70411913 -3.4587472e-08 -0.09831132 -0.09831132 -0.09831132 - 15700 1.57 0.70412918 0.70412814 -9.8178579e-09 -0.098316392 -0.098316392 -0.098316392 - 15710 1.571 0.70413816 0.70413712 1.4813146e-08 -0.09832145 -0.09832145 -0.09832145 - 15720 1.572 0.70414711 0.70414606 3.8744037e-08 -0.098326492 -0.098326492 -0.098326492 - 15730 1.573 0.70415604 0.70415498 6.143091e-08 -0.09833152 -0.09833152 -0.09833152 - 15740 1.574 0.70416495 0.70416387 8.2359818e-08 -0.098336532 -0.098336532 -0.098336532 - 15750 1.575 0.70417383 0.70417273 1.0105841e-07 -0.098341529 -0.098341529 -0.098341529 - 15760 1.576 0.70418269 0.70418156 1.1710658e-07 -0.098346512 -0.098346512 -0.098346512 - 15770 1.577 0.70419153 0.70419036 1.3014592e-07 -0.098351479 -0.098351479 -0.098351479 - 15780 1.578 0.70420033 0.70419914 1.3988771e-07 -0.098356432 -0.098356432 -0.098356432 - 15790 1.579 0.70420912 0.70420789 1.461193e-07 -0.09836137 -0.09836137 -0.09836137 - 15800 1.58 0.70421787 0.70421661 1.4870876e-07 -0.098366294 -0.098366294 -0.098366294 - 15810 1.581 0.7042266 0.70422531 1.4760765e-07 -0.098371202 -0.098371202 -0.098371202 - 15820 1.582 0.70423531 0.70423398 1.4285187e-07 -0.098376096 -0.098376096 -0.098376096 - 15830 1.583 0.70424398 0.70424262 1.3456062e-07 -0.098380975 -0.098380975 -0.098380975 - 15840 1.584 0.70425263 0.70425124 1.2293345e-07 -0.09838584 -0.09838584 -0.09838584 - 15850 1.585 0.70426126 0.70425984 1.0824544e-07 -0.09839069 -0.09839069 -0.09839069 - 15860 1.586 0.70426985 0.70426841 9.0840722e-08 -0.098395526 -0.098395526 -0.098395526 - 15870 1.587 0.70427842 0.70427696 7.1124441e-08 -0.098400347 -0.098400347 -0.098400347 - 15880 1.588 0.70428696 0.70428548 4.9553316e-08 -0.098405154 -0.098405154 -0.098405154 - 15890 1.589 0.70429547 0.70429398 2.6625073e-08 -0.098409947 -0.098409947 -0.098409947 - 15900 1.59 0.70430395 0.70430246 2.8669696e-09 -0.098414725 -0.098414725 -0.098414725 - 15910 1.591 0.70431241 0.70431091 -2.1176328e-08 -0.098419489 -0.098419489 -0.098419489 - 15920 1.592 0.70432084 0.70431935 -4.4955223e-08 -0.098424239 -0.098424239 -0.098424239 - 15930 1.593 0.70432924 0.70432776 -6.792775e-08 -0.098428975 -0.098428975 -0.098428975 - 15940 1.594 0.70433761 0.70433614 -8.9571923e-08 -0.098433696 -0.098433696 -0.098433696 - 15950 1.595 0.70434595 0.70434451 -1.0939759e-07 -0.098438403 -0.098438403 -0.098438403 - 15960 1.596 0.70435427 0.70435285 -1.2695754e-07 -0.098443097 -0.098443097 -0.098443097 - 15970 1.597 0.70436256 0.70436116 -1.4185757e-07 -0.098447776 -0.098447776 -0.098447776 - 15980 1.598 0.70437083 0.70436946 -1.5376534e-07 -0.098452441 -0.098452441 -0.098452441 - 15990 1.599 0.70437907 0.70437773 -1.624178e-07 -0.098457093 -0.098457093 -0.098457093 - 16000 1.6 0.70438728 0.70438597 -1.6762696e-07 -0.09846173 -0.09846173 -0.09846173 - 16010 1.601 0.70439547 0.7043942 -1.6928399e-07 -0.098466354 -0.098466354 -0.098466354 - 16020 1.602 0.70440363 0.70440239 -1.6736147e-07 -0.098470963 -0.098470963 -0.098470963 - 16030 1.603 0.70441177 0.70441057 -1.6191378e-07 -0.098475559 -0.098475559 -0.098475559 - 16040 1.604 0.70441989 0.70441871 -1.5307563e-07 -0.098480142 -0.098480142 -0.098480142 - 16050 1.605 0.70442798 0.70442683 -1.4105875e-07 -0.09848471 -0.09848471 -0.09848471 - 16060 1.606 0.70443605 0.70443493 -1.2614681e-07 -0.098489265 -0.098489265 -0.098489265 - 16070 1.607 0.7044441 0.704443 -1.0868876e-07 -0.098493807 -0.098493807 -0.098493807 - 16080 1.608 0.70445212 0.70445104 -8.9090701e-08 -0.098498334 -0.098498334 -0.098498334 - 16090 1.609 0.70446013 0.70445906 -6.7806377e-08 -0.098502849 -0.098502849 -0.098502849 - 16100 1.61 0.70446811 0.70446705 -4.5326735e-08 -0.098507349 -0.098507349 -0.098507349 - 16110 1.611 0.70447607 0.70447502 -2.2168584e-08 -0.098511837 -0.098511837 -0.098511837 - 16120 1.612 0.70448401 0.70448295 1.1372758e-09 -0.098516311 -0.098516311 -0.098516311 - 16130 1.613 0.70449193 0.70449087 2.4058218e-08 -0.098520771 -0.098520771 -0.098520771 - 16140 1.614 0.70449982 0.70449875 4.6071956e-08 -0.098525218 -0.098525218 -0.098525218 - 16150 1.615 0.7045077 0.70450661 6.6678439e-08 -0.098529652 -0.098529652 -0.098529652 - 16160 1.616 0.70451555 0.70451445 8.5411213e-08 -0.098534073 -0.098534073 -0.098534073 - 16170 1.617 0.70452338 0.70452225 1.0184797e-07 -0.09853848 -0.09853848 -0.09853848 - 16180 1.618 0.70453119 0.70453004 1.1562006e-07 -0.098542874 -0.098542874 -0.098542874 - 16190 1.619 0.70453898 0.7045378 1.2642079e-07 -0.098547256 -0.098547256 -0.098547256 - 16200 1.62 0.70454674 0.70454553 1.3401219e-07 -0.098551624 -0.098551624 -0.098551624 - 16210 1.621 0.70455449 0.70455324 1.382303e-07 -0.098555978 -0.098555978 -0.098555978 - 16220 1.622 0.70456221 0.70456093 1.3898867e-07 -0.09856032 -0.09856032 -0.09856032 - 16230 1.623 0.7045699 0.70456859 1.3628015e-07 -0.098564649 -0.098564649 -0.098564649 - 16240 1.624 0.70457758 0.70457623 1.3017678e-07 -0.098568965 -0.098568965 -0.098568965 - 16250 1.625 0.70458522 0.70458385 1.2082792e-07 -0.098573268 -0.098573268 -0.098573268 - 16260 1.626 0.70459285 0.70459145 1.0845664e-07 -0.098577559 -0.098577559 -0.098577559 - 16270 1.627 0.70460045 0.70459903 9.3354414e-08 -0.098581836 -0.098581836 -0.098581836 - 16280 1.628 0.70460803 0.70460658 7.5874224e-08 -0.098586101 -0.098586101 -0.098586101 - 16290 1.629 0.70461558 0.70461412 5.6422355e-08 -0.098590352 -0.098590352 -0.098590352 - 16300 1.63 0.7046231 0.70462163 3.5448945e-08 -0.098594591 -0.098594591 -0.098594591 - 16310 1.631 0.70463061 0.70462913 1.3437578e-08 -0.098598818 -0.098598818 -0.098598818 - 16320 1.632 0.70463808 0.7046366 -9.1058606e-09 -0.098603032 -0.098603032 -0.098603032 - 16330 1.633 0.70464553 0.70464405 -3.1664807e-08 -0.098607233 -0.098607233 -0.098607233 - 16340 1.634 0.70465296 0.70465149 -5.372385e-08 -0.098611421 -0.098611421 -0.098611421 - 16350 1.635 0.70466036 0.7046589 -7.4780503e-08 -0.098615598 -0.098615598 -0.098615598 - 16360 1.636 0.70466774 0.7046663 -9.4356646e-08 -0.098619761 -0.098619761 -0.098619761 - 16370 1.637 0.7046751 0.70467367 -1.1200938e-07 -0.098623912 -0.098623912 -0.098623912 - 16380 1.638 0.70468243 0.70468102 -1.2734106e-07 -0.098628051 -0.098628051 -0.098628051 - 16390 1.639 0.70468973 0.70468836 -1.4000819e-07 -0.098632177 -0.098632177 -0.098632177 - 16400 1.64 0.70469702 0.70469567 -1.4972922e-07 -0.098636291 -0.098636291 -0.098636291 - 16410 1.641 0.70470428 0.70470296 -1.5629068e-07 -0.098640393 -0.098640393 -0.098640393 - 16420 1.642 0.70471152 0.70471023 -1.5955195e-07 -0.098644482 -0.098644482 -0.098644482 - 16430 1.643 0.70471873 0.70471748 -1.5944822e-07 -0.098648559 -0.098648559 -0.098648559 - 16440 1.644 0.70472593 0.7047247 -1.5599177e-07 -0.098652624 -0.098652624 -0.098652624 - 16450 1.645 0.7047331 0.70473191 -1.4927144e-07 -0.098656677 -0.098656677 -0.098656677 - 16460 1.646 0.70474025 0.70473909 -1.3945041e-07 -0.098660718 -0.098660718 -0.098660718 - 16470 1.647 0.70474739 0.70474624 -1.2676223e-07 -0.098664746 -0.098664746 -0.098664746 - 16480 1.648 0.7047545 0.70475338 -1.115053e-07 -0.098668763 -0.098668763 -0.098668763 - 16490 1.649 0.70476159 0.70476049 -9.4035824e-08 -0.098672767 -0.098672767 -0.098672767 - 16500 1.65 0.70476867 0.70476758 -7.475956e-08 -0.09867676 -0.09867676 -0.09867676 - 16510 1.651 0.70477572 0.70477465 -5.4122352e-08 -0.09868074 -0.09868074 -0.09868074 - 16520 1.652 0.70478276 0.70478169 -3.259985e-08 -0.098684709 -0.098684709 -0.098684709 - 16530 1.653 0.70478977 0.70478871 -1.0686544e-08 -0.098688666 -0.098688666 -0.098688666 - 16540 1.654 0.70479677 0.7047957 1.111559e-08 -0.098692611 -0.098692611 -0.098692611 - 16550 1.655 0.70480375 0.70480267 3.2308584e-08 -0.098696544 -0.098696544 -0.098696544 - 16560 1.656 0.70481071 0.70480962 5.2409852e-08 -0.098700465 -0.098700465 -0.098700465 - 16570 1.657 0.70481765 0.70481655 7.096317e-08 -0.098704374 -0.098704374 -0.098704374 - 16580 1.658 0.70482458 0.70482345 8.7549031e-08 -0.098708272 -0.098708272 -0.098708272 - 16590 1.659 0.70483148 0.70483033 1.0179413e-07 -0.098712158 -0.098712158 -0.098712158 - 16600 1.66 0.70483837 0.70483719 1.1337974e-07 -0.098716033 -0.098716033 -0.098716033 - 16610 1.661 0.70484523 0.70484403 1.2204889e-07 -0.098719896 -0.098719896 -0.098719896 - 16620 1.662 0.70485208 0.70485084 1.27612e-07 -0.098723747 -0.098723747 -0.098723747 - 16630 1.663 0.7048589 0.70485764 1.2995106e-07 -0.098727587 -0.098727587 -0.098727587 - 16640 1.664 0.7048657 0.70486441 1.290221e-07 -0.098731415 -0.098731415 -0.098731415 - 16650 1.665 0.70487249 0.70487117 1.2485598e-07 -0.098735232 -0.098735232 -0.098735232 - 16660 1.666 0.70487925 0.7048779 1.1755749e-07 -0.098739038 -0.098739038 -0.098739038 - 16670 1.667 0.70488599 0.70488461 1.0730269e-07 -0.098742832 -0.098742832 -0.098742832 - 16680 1.668 0.70489271 0.70489131 9.4334741e-08 -0.098746614 -0.098746614 -0.098746614 - 16690 1.669 0.70489941 0.70489799 7.89581e-08 -0.098750386 -0.098750386 -0.098750386 - 16700 1.67 0.70490609 0.70490465 6.1531405e-08 -0.098754146 -0.098754146 -0.098754146 - 16710 1.671 0.70491274 0.70491129 4.2459112e-08 -0.098757894 -0.098757894 -0.098757894 - 16720 1.672 0.70491938 0.70491791 2.2182113e-08 -0.098761632 -0.098761632 -0.098761632 - 16730 1.673 0.70492599 0.70492452 1.1675535e-09 -0.098765358 -0.098765358 -0.098765358 - 16740 1.674 0.70493257 0.7049311 -2.0101928e-08 -0.098769073 -0.098769073 -0.098769073 - 16750 1.675 0.70493914 0.70493767 -4.113928e-08 -0.098772777 -0.098772777 -0.098772777 - 16760 1.676 0.70494568 0.70494423 -6.1464185e-08 -0.09877647 -0.09877647 -0.09877647 - 16770 1.677 0.70495221 0.70495076 -8.0614024e-08 -0.098780152 -0.098780152 -0.098780152 - 16780 1.678 0.70495871 0.70495728 -9.8154404e-08 -0.098783823 -0.098783823 -0.098783823 - 16790 1.679 0.70496519 0.70496378 -1.1368901e-07 -0.098787483 -0.098787483 -0.098787483 - 16800 1.68 0.70497165 0.70497026 -1.2686854e-07 -0.098791132 -0.098791132 -0.098791132 - 16810 1.681 0.70497808 0.70497672 -1.3739859e-07 -0.09879477 -0.09879477 -0.09879477 - 16820 1.682 0.7049845 0.70498317 -1.4504619e-07 -0.098798397 -0.098798397 -0.098798397 - 16830 1.683 0.7049909 0.7049896 -1.4964497e-07 -0.098802013 -0.098802013 -0.098802013 - 16840 1.684 0.70499728 0.704996 -1.5109878e-07 -0.098805618 -0.098805618 -0.098805618 - 16850 1.685 0.70500363 0.70500239 -1.4938365e-07 -0.098809212 -0.098809212 -0.098809212 - 16860 1.686 0.70500997 0.70500876 -1.4454818e-07 -0.098812796 -0.098812796 -0.098812796 - 16870 1.687 0.7050163 0.70501511 -1.3671215e-07 -0.098816369 -0.098816369 -0.098816369 - 16880 1.688 0.7050226 0.70502144 -1.2606364e-07 -0.098819931 -0.098819931 -0.098819931 - 16890 1.689 0.70502888 0.70502775 -1.1285449e-07 -0.098823483 -0.098823483 -0.098823483 - 16900 1.69 0.70503515 0.70503403 -9.7394347e-08 -0.098827024 -0.098827024 -0.098827024 - 16910 1.691 0.7050414 0.7050403 -8.0043457e-08 -0.098830554 -0.098830554 -0.098830554 - 16920 1.692 0.70504764 0.70504655 -6.1204235e-08 -0.098834074 -0.098834074 -0.098834074 - 16930 1.693 0.70505386 0.70505277 -4.1311958e-08 -0.098837583 -0.098837583 -0.098837583 - 16940 1.694 0.70506006 0.70505898 -2.0824711e-08 -0.098841082 -0.098841082 -0.098841082 - 16950 1.695 0.70506624 0.70506516 -2.128402e-10 -0.09884457 -0.09884457 -0.09884457 - 16960 1.696 0.70507241 0.70507132 2.0051838e-08 -0.098848048 -0.098848048 -0.098848048 - 16970 1.697 0.70507856 0.70507747 3.9506835e-08 -0.098851515 -0.098851515 -0.098851515 - 16980 1.698 0.7050847 0.70508359 5.7709542e-08 -0.098854972 -0.098854972 -0.098854972 - 16990 1.699 0.70509082 0.70508969 7.4247296e-08 -0.098858418 -0.098858418 -0.098858418 - 17000 1.7 0.70509692 0.70509577 8.8746729e-08 -0.098861854 -0.098861854 -0.098861854 - 17010 1.701 0.705103 0.70510183 1.008822e-07 -0.09886528 -0.09886528 -0.09886528 - 17020 1.702 0.70510907 0.70510788 1.103831e-07 -0.098868696 -0.098868696 -0.098868696 - 17030 1.703 0.70511512 0.7051139 1.1703987e-07 -0.098872101 -0.098872101 -0.098872101 - 17040 1.704 0.70512115 0.7051199 1.2070866e-07 -0.098875496 -0.098875496 -0.098875496 - 17050 1.705 0.70512717 0.70512589 1.2131436e-07 -0.098878881 -0.098878881 -0.098878881 - 17060 1.706 0.70513317 0.70513186 1.1885218e-07 -0.098882256 -0.098882256 -0.098882256 - 17070 1.707 0.70513915 0.70513781 1.1338751e-07 -0.098885621 -0.098885621 -0.098885621 - 17080 1.708 0.7051451 0.70514374 1.0505425e-07 -0.098888975 -0.098888975 -0.098888975 - 17090 1.709 0.70515105 0.70514966 9.4051537e-08 -0.09889232 -0.09889232 -0.09889232 - 17100 1.71 0.70515697 0.70515556 8.0638973e-08 -0.098895654 -0.098895654 -0.098895654 - 17110 1.711 0.70516287 0.70516145 6.5130548e-08 -0.098898978 -0.098898978 -0.098898978 - 17120 1.712 0.70516875 0.70516731 4.7887273e-08 -0.098902293 -0.098902293 -0.098902293 - 17130 1.713 0.70517462 0.70517317 2.930879e-08 -0.098905597 -0.098905597 -0.098905597 - 17140 1.714 0.70518046 0.705179 9.8241129e-09 -0.098908892 -0.098908892 -0.098908892 - 17150 1.715 0.70518628 0.70518482 -1.0118272e-08 -0.098912177 -0.098912177 -0.098912177 - 17160 1.716 0.70519209 0.70519063 -3.0060726e-08 -0.098915452 -0.098915452 -0.098915452 - 17170 1.717 0.70519787 0.70519642 -4.9546956e-08 -0.098918717 -0.098918717 -0.098918717 - 17180 1.718 0.70520364 0.7052022 -6.8132453e-08 -0.098921972 -0.098921972 -0.098921972 - 17190 1.719 0.70520938 0.70520796 -8.5394625e-08 -0.098925217 -0.098925217 -0.098925217 - 17200 1.72 0.70521511 0.7052137 -1.009424e-07 -0.098928453 -0.098928453 -0.098928453 - 17210 1.721 0.70522082 0.70521943 -1.144251e-07 -0.098931679 -0.098931679 -0.098931679 - 17220 1.722 0.70522651 0.70522514 -1.2554032e-07 -0.098934896 -0.098934896 -0.098934896 - 17230 1.723 0.70523218 0.70523084 -1.3404073e-07 -0.098938102 -0.098938102 -0.098938102 - 17240 1.724 0.70523783 0.70523652 -1.3973956e-07 -0.098941299 -0.098941299 -0.098941299 - 17250 1.725 0.70524347 0.70524218 -1.4251469e-07 -0.098944487 -0.098944487 -0.098944487 - 17260 1.726 0.70524909 0.70524783 -1.4231129e-07 -0.098947665 -0.098947665 -0.098947665 - 17270 1.727 0.70525469 0.70525346 -1.3914283e-07 -0.098950833 -0.098950833 -0.098950833 - 17280 1.728 0.70526027 0.70525907 -1.3309062e-07 -0.098953992 -0.098953992 -0.098953992 - 17290 1.729 0.70526584 0.70526466 -1.243017e-07 -0.098957141 -0.098957141 -0.098957141 - 17300 1.73 0.7052714 0.70527024 -1.1298532e-07 -0.098960281 -0.098960281 -0.098960281 - 17310 1.731 0.70527694 0.7052758 -9.9407949e-08 -0.098963411 -0.098963411 -0.098963411 - 17320 1.732 0.70528246 0.70528134 -8.3887032e-08 -0.098966533 -0.098966533 -0.098966533 - 17330 1.733 0.70528797 0.70528686 -6.6783544e-08 -0.098969644 -0.098969644 -0.098969644 - 17340 1.734 0.70529346 0.70529236 -4.8493623e-08 -0.098972747 -0.098972747 -0.098972747 - 17350 1.735 0.70529894 0.70529785 -2.9439391e-08 -0.09897584 -0.09897584 -0.09897584 - 17360 1.736 0.70530441 0.70530332 -1.0059218e-08 -0.098978923 -0.098978923 -0.098978923 - 17370 1.737 0.70530986 0.70530876 9.2023572e-09 -0.098981998 -0.098981998 -0.098981998 - 17380 1.738 0.70531529 0.70531419 2.7904822e-08 -0.098985063 -0.098985063 -0.098985063 - 17390 1.739 0.70532071 0.7053196 4.5621759e-08 -0.098988119 -0.098988119 -0.098988119 - 17400 1.74 0.70532612 0.705325 6.1950569e-08 -0.098991166 -0.098991166 -0.098991166 - 17410 1.741 0.70533151 0.70533037 7.6521611e-08 -0.098994204 -0.098994204 -0.098994204 - 17420 1.742 0.70533689 0.70533573 8.9006571e-08 -0.098997232 -0.098997232 -0.098997232 - 17430 1.743 0.70534225 0.70534107 9.9125854e-08 -0.099000252 -0.099000252 -0.099000252 - 17440 1.744 0.7053476 0.70534639 1.0665484e-07 -0.099003262 -0.099003262 -0.099003262 - 17450 1.745 0.70535293 0.7053517 1.1142887e-07 -0.099006264 -0.099006264 -0.099006264 - 17460 1.746 0.70535825 0.70535699 1.1334683e-07 -0.099009256 -0.099009256 -0.099009256 - 17470 1.747 0.70536355 0.70536226 1.1237329e-07 -0.099012239 -0.099012239 -0.099012239 - 17480 1.748 0.70536884 0.70536752 1.085391e-07 -0.099015214 -0.099015214 -0.099015214 - 17490 1.749 0.7053741 0.70537276 1.0194053e-07 -0.099018179 -0.099018179 -0.099018179 - 17500 1.75 0.70537936 0.70537799 9.2736828e-08 -0.099021136 -0.099021136 -0.099021136 - 17510 1.751 0.70538459 0.7053832 8.1146424e-08 -0.099024084 -0.099024084 -0.099024084 - 17520 1.752 0.70538981 0.7053884 6.7441735e-08 -0.099027023 -0.099027023 -0.099027023 - 17530 1.753 0.70539501 0.70539358 5.1942781e-08 -0.099029953 -0.099029953 -0.099029953 - 17540 1.754 0.70540019 0.70539875 3.500971e-08 -0.099032874 -0.099032874 -0.099032874 - 17550 1.755 0.70540535 0.70540391 1.7034444e-08 -0.099035786 -0.099035786 -0.099035786 - 17560 1.756 0.7054105 0.70540906 -1.5683958e-09 -0.09903869 -0.09903869 -0.09903869 - 17570 1.757 0.70541563 0.70541419 -2.0371043e-08 -0.099041585 -0.099041585 -0.099041585 - 17580 1.758 0.70542074 0.7054193 -3.894242e-08 -0.099044471 -0.099044471 -0.099044471 - 17590 1.759 0.70542584 0.7054244 -5.685802e-08 -0.099047349 -0.099047349 -0.099047349 - 17600 1.76 0.70543092 0.70542949 -7.3709601e-08 -0.099050218 -0.099050218 -0.099050218 - 17610 1.761 0.70543598 0.70543457 -8.9114493e-08 -0.099053078 -0.099053078 -0.099053078 - 17620 1.762 0.70544102 0.70543963 -1.0272428e-07 -0.09905593 -0.09905593 -0.09905593 - 17630 1.763 0.70544605 0.70544468 -1.1423268e-07 -0.099058773 -0.099058773 -0.099058773 - 17640 1.764 0.70545106 0.70544972 -1.2338242e-07 -0.099061607 -0.099061607 -0.099061607 - 17650 1.765 0.70545606 0.70545474 -1.2997101e-07 -0.099064433 -0.099064433 -0.099064433 - 17660 1.766 0.70546104 0.70545974 -1.3385519e-07 -0.099067251 -0.099067251 -0.099067251 - 17670 1.767 0.705466 0.70546473 -1.3495407e-07 -0.09907006 -0.09907006 -0.09907006 - 17680 1.768 0.70547095 0.70546971 -1.3325075e-07 -0.099072861 -0.099072861 -0.099072861 - 17690 1.769 0.70547589 0.70547467 -1.2879257e-07 -0.099075653 -0.099075653 -0.099075653 - 17700 1.77 0.70548081 0.70547961 -1.216898e-07 -0.099078437 -0.099078437 -0.099078437 - 17710 1.771 0.70548571 0.70548454 -1.1211294e-07 -0.099081212 -0.099081212 -0.099081212 - 17720 1.772 0.70549061 0.70548945 -1.0028866e-07 -0.09908398 -0.09908398 -0.09908398 - 17730 1.773 0.70549549 0.70549435 -8.6494411e-08 -0.099086738 -0.099086738 -0.099086738 - 17740 1.774 0.70550035 0.70549923 -7.1051936e-08 -0.099089489 -0.099089489 -0.099089489 - 17750 1.775 0.70550521 0.7055041 -5.4319777e-08 -0.099092231 -0.099092231 -0.099092231 - 17760 1.776 0.70551005 0.70550894 -3.6684948e-08 -0.099094965 -0.099094965 -0.099094965 - 17770 1.777 0.70551488 0.70551377 -1.855399e-08 -0.099097691 -0.099097691 -0.099097691 - 17780 1.778 0.70551969 0.70551859 -3.4360344e-10 -0.099100409 -0.099100409 -0.099100409 - 17790 1.779 0.70552449 0.70552339 1.7528926e-08 -0.099103118 -0.099103118 -0.099103118 - 17800 1.78 0.70552928 0.70552817 3.4655283e-08 -0.099105819 -0.099105819 -0.099105819 - 17810 1.781 0.70553406 0.70553293 5.0645452e-08 -0.099108513 -0.099108513 -0.099108513 - 17820 1.782 0.70553883 0.70553768 6.5136593e-08 -0.099111198 -0.099111198 -0.099111198 - 17830 1.783 0.70554358 0.70554242 7.7801273e-08 -0.099113875 -0.099113875 -0.099113875 - 17840 1.784 0.70554832 0.70554714 8.8354857e-08 -0.099116544 -0.099116544 -0.099116544 - 17850 1.785 0.70555304 0.70555184 9.6561908e-08 -0.099119205 -0.099119205 -0.099119205 - 17860 1.786 0.70555776 0.70555653 1.0224143e-07 -0.099121857 -0.099121857 -0.099121857 - 17870 1.787 0.70556246 0.7055612 1.0527086e-07 -0.099124502 -0.099124502 -0.099124502 - 17880 1.788 0.70556714 0.70556586 1.0558868e-07 -0.099127139 -0.099127139 -0.099127139 - 17890 1.789 0.70557181 0.7055705 1.0319568e-07 -0.099129768 -0.099129768 -0.099129768 - 17900 1.79 0.70557647 0.70557514 9.8154728e-08 -0.09913239 -0.09913239 -0.09913239 - 17910 1.791 0.70558111 0.70557975 9.0589173e-08 -0.099135003 -0.099135003 -0.099135003 - 17920 1.792 0.70558573 0.70558436 8.0679815e-08 -0.099137608 -0.099137608 -0.099137608 - 17930 1.793 0.70559034 0.70558895 6.8660607e-08 -0.099140206 -0.099140206 -0.099140206 - 17940 1.794 0.70559494 0.70559353 5.481314e-08 -0.099142796 -0.099142796 -0.099142796 - 17950 1.795 0.70559952 0.7055981 3.9460048e-08 -0.099145378 -0.099145378 -0.099145378 - 17960 1.796 0.70560409 0.70560266 2.2957502e-08 -0.099147952 -0.099147952 -0.099147952 - 17970 1.797 0.70560864 0.7056072 5.6869442e-09 -0.099150518 -0.099150518 -0.099150518 - 17980 1.798 0.70561317 0.70561173 -1.1953717e-08 -0.099153077 -0.099153077 -0.099153077 - 17990 1.799 0.70561769 0.70561625 -2.9559276e-08 -0.099155628 -0.099155628 -0.099155628 - 18000 1.8 0.70562219 0.70562076 -4.6726531e-08 -0.099158171 -0.099158171 -0.099158171 - 18010 1.801 0.70562668 0.70562526 -6.3063516e-08 -0.099160707 -0.099160707 -0.099160707 - 18020 1.802 0.70563115 0.70562974 -7.819845e-08 -0.099163235 -0.099163235 -0.099163235 - 18030 1.803 0.70563561 0.70563422 -9.1788187e-08 -0.099165756 -0.099165756 -0.099165756 - 18040 1.804 0.70564005 0.70563868 -1.03526e-07 -0.099168268 -0.099168268 -0.099168268 - 18050 1.805 0.70564448 0.70564312 -1.131485e-07 -0.099170774 -0.099170774 -0.099170774 - 18060 1.806 0.70564889 0.70564756 -1.2044154e-07 -0.099173272 -0.099173272 -0.099173272 - 18070 1.807 0.70565329 0.70565198 -1.2524497e-07 -0.099175762 -0.099175762 -0.099175762 - 18080 1.808 0.70565768 0.70565639 -1.2745617e-07 -0.099178245 -0.099178245 -0.099178245 - 18090 1.809 0.70566205 0.70566079 -1.2703218e-07 -0.09918072 -0.09918072 -0.09918072 - 18100 1.81 0.70566641 0.70566518 -1.2399058e-07 -0.099183188 -0.099183188 -0.099183188 - 18110 1.811 0.70567076 0.70566955 -1.1840886e-07 -0.099185648 -0.099185648 -0.099185648 - 18120 1.812 0.70567509 0.7056739 -1.1042245e-07 -0.099188101 -0.099188101 -0.099188101 - 18130 1.813 0.70567941 0.70567824 -1.0022152e-07 -0.099190547 -0.099190547 -0.099190547 - 18140 1.814 0.70568372 0.70568257 -8.8046375e-08 -0.099192985 -0.099192985 -0.099192985 - 18150 1.815 0.70568802 0.70568688 -7.4181867e-08 -0.099195416 -0.099195416 -0.099195416 - 18160 1.816 0.70569231 0.70569118 -5.8950699e-08 -0.09919784 -0.09919784 -0.09919784 - 18170 1.817 0.70569659 0.70569547 -4.2705933e-08 -0.099200256 -0.099200256 -0.099200256 - 18180 1.818 0.70570085 0.70569974 -2.5822808e-08 -0.099202665 -0.099202665 -0.099202665 - 18190 1.819 0.7057051 0.70570399 -8.690076e-09 -0.099205067 -0.099205067 -0.099205067 - 18200 1.82 0.70570935 0.70570823 8.2989437e-09 -0.099207462 -0.099207462 -0.099207462 - 18210 1.821 0.70571358 0.70571246 2.4755394e-08 -0.099209849 -0.099209849 -0.099209849 - 18220 1.822 0.7057178 0.70571667 4.0303774e-08 -0.099212229 -0.099212229 -0.099212229 - 18230 1.823 0.70572201 0.70572087 5.4590506e-08 -0.099214602 -0.099214602 -0.099214602 - 18240 1.824 0.70572621 0.70572505 6.7291973e-08 -0.099216968 -0.099216968 -0.099216968 - 18250 1.825 0.7057304 0.70572922 7.8121845e-08 -0.099219327 -0.099219327 -0.099219327 - 18260 1.826 0.70573457 0.70573337 8.683753e-08 -0.099221679 -0.099221679 -0.099221679 - 18270 1.827 0.70573874 0.70573751 9.3245603e-08 -0.099224023 -0.099224023 -0.099224023 - 18280 1.828 0.70574289 0.70574164 9.7206098e-08 -0.099226361 -0.099226361 -0.099226361 - 18290 1.829 0.70574703 0.70574576 9.8635549e-08 -0.099228691 -0.099228691 -0.099228691 - 18300 1.83 0.70575116 0.70574986 9.7508745e-08 -0.099231015 -0.099231015 -0.099231015 - 18310 1.831 0.70575527 0.70575395 9.3859127e-08 -0.099233331 -0.099233331 -0.099233331 - 18320 1.832 0.70575937 0.70575803 8.7777853e-08 -0.099235641 -0.099235641 -0.099235641 - 18330 1.833 0.70576346 0.7057621 7.941154e-08 -0.099237943 -0.099237943 -0.099237943 - 18340 1.834 0.70576754 0.70576616 6.8958732e-08 -0.099240239 -0.099240239 -0.099240239 - 18350 1.835 0.7057716 0.7057702 5.6665204e-08 -0.099242528 -0.099242528 -0.099242528 - 18360 1.836 0.70577565 0.70577424 4.2818186e-08 -0.099244809 -0.099244809 -0.099244809 - 18370 1.837 0.70577968 0.70577826 2.7739657e-08 -0.099247084 -0.099247084 -0.099247084 - 18380 1.838 0.7057837 0.70578228 1.1778865e-08 -0.099249353 -0.099249353 -0.099249353 - 18390 1.839 0.70578771 0.70578628 -4.6957605e-09 -0.099251614 -0.099251614 -0.099251614 - 18400 1.84 0.7057917 0.70579027 -2.1305108e-08 -0.099253868 -0.099253868 -0.099253868 - 18410 1.841 0.70579568 0.70579425 -3.7668103e-08 -0.099256116 -0.099256116 -0.099256116 - 18420 1.842 0.70579964 0.70579823 -5.3410454e-08 -0.099258357 -0.099258357 -0.099258357 - 18430 1.843 0.7058036 0.70580219 -6.8173204e-08 -0.099260591 -0.099260591 -0.099260591 - 18440 1.844 0.70580753 0.70580614 -8.1620914e-08 -0.099262818 -0.099262818 -0.099262818 - 18450 1.845 0.70581146 0.70581008 -9.3449288e-08 -0.099265039 -0.099265039 -0.099265039 - 18460 1.846 0.70581537 0.70581401 -1.0339205e-07 -0.099267253 -0.099267253 -0.099267253 - 18470 1.847 0.70581927 0.70581793 -1.1122692e-07 -0.099269461 -0.099269461 -0.099269461 - 18480 1.848 0.70582316 0.70582184 -1.1678063e-07 -0.099271661 -0.099271661 -0.099271661 - 18490 1.849 0.70582703 0.70582574 -1.1993267e-07 -0.099273855 -0.099273855 -0.099273855 - 18500 1.85 0.70583089 0.70582962 -1.2061797e-07 -0.099276043 -0.099276043 -0.099276043 - 18510 1.851 0.70583474 0.7058335 -1.1882819e-07 -0.099278224 -0.099278224 -0.099278224 - 18520 1.852 0.70583858 0.70583736 -1.1461174e-07 -0.099280398 -0.099280398 -0.099280398 - 18530 1.853 0.70584241 0.70584121 -1.0807252e-07 -0.099282566 -0.099282566 -0.099282566 - 18540 1.854 0.70584623 0.70584505 -9.9367345e-08 -0.099284727 -0.099284727 -0.099284727 - 18550 1.855 0.70585004 0.70584887 -8.8702244e-08 -0.099286882 -0.099286882 -0.099286882 - 18560 1.856 0.70585383 0.70585268 -7.6327541e-08 -0.09928903 -0.09928903 -0.09928903 - 18570 1.857 0.70585762 0.70585648 -6.2532008e-08 -0.099291172 -0.099291172 -0.099291172 - 18580 1.858 0.7058614 0.70586027 -4.7636131e-08 -0.099293307 -0.099293307 -0.099293307 - 18590 1.859 0.70586517 0.70586404 -3.1984665e-08 -0.099295436 -0.099295436 -0.099295436 - 18600 1.86 0.70586892 0.7058678 -1.593866e-08 -0.099297558 -0.099297558 -0.099297558 - 18610 1.861 0.70587267 0.70587155 1.3286207e-10 -0.099299674 -0.099299674 -0.099299674 - 18620 1.862 0.70587641 0.70587528 1.5861394e-08 -0.099301784 -0.099301784 -0.099301784 - 18630 1.863 0.70588014 0.705879 3.0887388e-08 -0.099303888 -0.099303888 -0.099303888 - 18640 1.864 0.70588386 0.70588271 4.4868472e-08 -0.099305985 -0.099305985 -0.099305985 - 18650 1.865 0.70588757 0.7058864 5.7487246e-08 -0.099308075 -0.099308075 -0.099308075 - 18660 1.866 0.70589127 0.70589009 6.8458489e-08 -0.09931016 -0.09931016 -0.09931016 - 18670 1.867 0.70589495 0.70589376 7.7535597e-08 -0.099312238 -0.099312238 -0.099312238 - 18680 1.868 0.70589863 0.70589742 8.4516128e-08 -0.09931431 -0.09931431 -0.09931431 - 18690 1.869 0.7059023 0.70590106 8.9246306e-08 -0.099316375 -0.099316375 -0.099316375 - 18700 1.87 0.70590596 0.7059047 9.1624407e-08 -0.099318435 -0.099318435 -0.099318435 - 18710 1.871 0.70590961 0.70590832 9.1602936e-08 -0.099320488 -0.099320488 -0.099320488 - 18720 1.872 0.70591324 0.70591194 8.9189552e-08 -0.099322535 -0.099322535 -0.099322535 - 18730 1.873 0.70591687 0.70591554 8.4446732e-08 -0.099324576 -0.099324576 -0.099324576 - 18740 1.874 0.70592048 0.70591913 7.7490175e-08 -0.09932661 -0.09932661 -0.09932661 - 18750 1.875 0.70592408 0.70592272 6.848599e-08 -0.099328639 -0.099328639 -0.099328639 - 18760 1.876 0.70592767 0.70592629 5.764674e-08 -0.099330661 -0.099330661 -0.099330661 - 18770 1.877 0.70593125 0.70592985 4.522643e-08 -0.099332677 -0.099332677 -0.099332677 - 18780 1.878 0.70593481 0.70593341 3.1514557e-08 -0.099334688 -0.099334688 -0.099334688 - 18790 1.879 0.70593837 0.70593695 1.6829372e-08 -0.099336692 -0.099336692 -0.099336692 - 18800 1.88 0.70594191 0.70594049 1.5104927e-09 -0.09933869 -0.09933869 -0.09933869 - 18810 1.881 0.70594544 0.70594402 -1.4088944e-08 -0.099340682 -0.099340682 -0.099340682 - 18820 1.882 0.70594895 0.70594753 -2.9610419e-08 -0.099342668 -0.099342668 -0.099342668 - 18830 1.883 0.70595245 0.70595104 -4.4698272e-08 -0.099344648 -0.099344648 -0.099344648 - 18840 1.884 0.70595595 0.70595454 -5.9007842e-08 -0.099346623 -0.099346623 -0.099346623 - 18850 1.885 0.70595943 0.70595803 -7.2213343e-08 -0.099348591 -0.099348591 -0.099348591 - 18860 1.886 0.70596289 0.70596152 -8.4015276e-08 -0.099350553 -0.099350553 -0.099350553 - 18870 1.887 0.70596635 0.70596499 -9.4147216e-08 -0.09935251 -0.09935251 -0.09935251 - 18880 1.888 0.70596979 0.70596845 -1.0238183e-07 -0.09935446 -0.09935446 -0.09935446 - 18890 1.889 0.70597323 0.7059719 -1.0853597e-07 -0.099356405 -0.099356405 -0.099356405 - 18900 1.89 0.70597665 0.70597535 -1.1247473e-07 -0.099358343 -0.099358343 -0.099358343 - 18910 1.891 0.70598006 0.70597878 -1.1411442e-07 -0.099360276 -0.099360276 -0.099360276 - 18920 1.892 0.70598346 0.7059822 -1.1342432e-07 -0.099362203 -0.099362203 -0.099362203 - 18930 1.893 0.70598685 0.70598562 -1.1042722e-07 -0.099364125 -0.099364125 -0.099364125 - 18940 1.894 0.70599023 0.70598902 -1.0519876e-07 -0.09936604 -0.09936604 -0.09936604 - 18950 1.895 0.70599361 0.70599241 -9.7865496e-08 -0.09936795 -0.09936795 -0.09936795 - 18960 1.896 0.70599697 0.70599579 -8.8601904e-08 -0.099369854 -0.099369854 -0.099369854 - 18970 1.897 0.70600032 0.70599916 -7.7626193e-08 -0.099371752 -0.099371752 -0.099371752 - 18980 1.898 0.70600367 0.70600251 -6.5195188e-08 -0.099373644 -0.099373644 -0.099373644 - 18990 1.899 0.706007 0.70600586 -5.1598322e-08 -0.099375531 -0.099375531 -0.099375531 - 19000 1.9 0.70601033 0.70600919 -3.71509e-08 -0.099377412 -0.099377412 -0.099377412 - 19010 1.901 0.70601365 0.70601252 -2.2186797e-08 -0.099379288 -0.099379288 -0.099379288 - 19020 1.902 0.70601696 0.70601583 -7.0507367e-09 -0.099381157 -0.099381157 -0.099381157 - 19030 1.903 0.70602026 0.70601913 7.9096381e-09 -0.099383021 -0.099383021 -0.099383021 - 19040 1.904 0.70602355 0.70602241 2.2351752e-08 -0.09938488 -0.09938488 -0.09938488 - 19050 1.905 0.70602684 0.70602569 3.5945938e-08 -0.099386733 -0.099386733 -0.099386733 - 19060 1.906 0.70603012 0.70602895 4.8382957e-08 -0.09938858 -0.09938858 -0.09938858 - 19070 1.907 0.70603338 0.70603221 5.9381035e-08 -0.099390422 -0.099390422 -0.099390422 - 19080 1.908 0.70603664 0.70603545 6.8692236e-08 -0.099392258 -0.099392258 -0.099392258 - 19090 1.909 0.70603989 0.70603868 7.6108057e-08 -0.099394089 -0.099394089 -0.099394089 - 19100 1.91 0.70604313 0.7060419 8.1464086e-08 -0.099395914 -0.099395914 -0.099395914 - 19110 1.911 0.70604637 0.70604511 8.4643642e-08 -0.099397733 -0.099397733 -0.099397733 - 19120 1.912 0.70604959 0.70604832 8.5580314e-08 -0.099399547 -0.099399547 -0.099399547 - 19130 1.913 0.7060528 0.70605151 8.4259331e-08 -0.099401356 -0.099401356 -0.099401356 - 19140 1.914 0.706056 0.70605469 8.0717747e-08 -0.099403159 -0.099403159 -0.099403159 - 19150 1.915 0.7060592 0.70605786 7.5043437e-08 -0.099404957 -0.099404957 -0.099404957 - 19160 1.916 0.70606238 0.70606103 6.7372934e-08 -0.099406749 -0.099406749 -0.099406749 - 19170 1.917 0.70606555 0.70606418 5.7888148e-08 -0.099408536 -0.099408536 -0.099408536 - 19180 1.918 0.70606871 0.70606733 4.6812058e-08 -0.099410318 -0.099410318 -0.099410318 - 19190 1.919 0.70607186 0.70607047 3.4403481e-08 -0.099412094 -0.099412094 -0.099412094 - 19200 1.92 0.706075 0.7060736 2.0951022e-08 -0.099413865 -0.099413865 -0.099413865 - 19210 1.921 0.70607813 0.70607672 6.7663709e-09 -0.09941563 -0.09941563 -0.09941563 - 19220 1.922 0.70608125 0.70607984 -7.8229194e-09 -0.099417391 -0.099417391 -0.099417391 - 19230 1.923 0.70608435 0.70608294 -2.2480992e-08 -0.099419145 -0.099419145 -0.099419145 - 19240 1.924 0.70608745 0.70608604 -3.6871415e-08 -0.099420895 -0.099420895 -0.099420895 - 19250 1.925 0.70609053 0.70608913 -5.0664901e-08 -0.099422639 -0.099422639 -0.099422639 - 19260 1.926 0.70609361 0.70609222 -6.3546837e-08 -0.099424378 -0.099424378 -0.099424378 - 19270 1.927 0.70609667 0.70609529 -7.5224461e-08 -0.099426112 -0.099426112 -0.099426112 - 19280 1.928 0.70609972 0.70609836 -8.543351e-08 -0.09942784 -0.09942784 -0.09942784 - 19290 1.929 0.70610277 0.70610142 -9.3944199e-08 -0.099429564 -0.099429564 -0.099429564 - 19300 1.93 0.7061058 0.70610447 -1.0056639e-07 -0.099431282 -0.099431282 -0.099431282 - 19310 1.931 0.70610882 0.70610751 -1.0515382e-07 -0.099432995 -0.099432995 -0.099432995 - 19320 1.932 0.70611183 0.70611055 -1.0760737e-07 -0.099434703 -0.099434703 -0.099434703 - 19330 1.933 0.70611484 0.70611357 -1.0787713e-07 -0.099436405 -0.099436405 -0.099436405 - 19340 1.934 0.70611783 0.70611659 -1.0596347e-07 -0.099438103 -0.099438103 -0.099438103 - 19350 1.935 0.70612082 0.70611959 -1.0191683e-07 -0.099439795 -0.099439795 -0.099439795 - 19360 1.936 0.7061238 0.70612259 -9.5836422e-08 -0.099441482 -0.099441482 -0.099441482 - 19370 1.937 0.70612677 0.70612557 -8.7867838e-08 -0.099443164 -0.099443164 -0.099443164 - 19380 1.938 0.70612973 0.70612855 -7.8199538e-08 -0.099444842 -0.099444842 -0.099444842 - 19390 1.939 0.70613268 0.70613152 -6.7058418e-08 -0.099446514 -0.099446514 -0.099446514 - 19400 1.94 0.70613563 0.70613447 -5.470448e-08 -0.099448181 -0.099448181 -0.099448181 - 19410 1.941 0.70613857 0.70613742 -4.1424778e-08 -0.099449843 -0.099449843 -0.099449843 - 19420 1.942 0.7061415 0.70614035 -2.7526741e-08 -0.099451499 -0.099451499 -0.099451499 - 19430 1.943 0.70614442 0.70614328 -1.333107e-08 -0.099453151 -0.099453151 -0.099453151 - 19440 1.944 0.70614734 0.70614619 8.3566774e-10 -0.099454798 -0.099454798 -0.099454798 - 19450 1.945 0.70615024 0.7061491 1.4648542e-08 -0.09945644 -0.09945644 -0.09945644 - 19460 1.946 0.70615315 0.70615199 2.7791714e-08 -0.099458077 -0.099458077 -0.099458077 - 19470 1.947 0.70615604 0.70615488 3.9965652e-08 -0.099459709 -0.099459709 -0.099459709 - 19480 1.948 0.70615893 0.70615775 5.0893959e-08 -0.099461337 -0.099461337 -0.099461337 - 19490 1.949 0.70616181 0.70616061 6.032964e-08 -0.099462959 -0.099462959 -0.099462959 - 19500 1.95 0.70616468 0.70616347 6.8060684e-08 -0.099464576 -0.099464576 -0.099464576 - 19510 1.951 0.70616754 0.70616631 7.3914827e-08 -0.099466189 -0.099466189 -0.099466189 - 19520 1.952 0.7061704 0.70616915 7.7763378e-08 -0.099467796 -0.099467796 -0.099467796 - 19530 1.953 0.70617324 0.70617198 7.952405e-08 -0.099469399 -0.099469399 -0.099469399 - 19540 1.954 0.70617608 0.7061748 7.9162704e-08 -0.099470997 -0.099470997 -0.099470997 - 19550 1.955 0.70617891 0.70617761 7.6693992e-08 -0.09947259 -0.09947259 -0.09947259 - 19560 1.956 0.70618173 0.70618041 7.2180872e-08 -0.099474178 -0.099474178 -0.099474178 - 19570 1.957 0.70618454 0.7061832 6.5733024e-08 -0.099475762 -0.099475762 -0.099475762 - 19580 1.958 0.70618735 0.70618599 5.7504189e-08 -0.099477341 -0.099477341 -0.099477341 - 19590 1.959 0.70619014 0.70618877 4.7688515e-08 -0.099478915 -0.099478915 -0.099478915 - 19600 1.96 0.70619292 0.70619154 3.6515978e-08 -0.099480484 -0.099480484 -0.099480484 - 19610 1.961 0.7061957 0.70619431 2.4246999e-08 -0.099482048 -0.099482048 -0.099482048 - 19620 1.962 0.70619846 0.70619706 1.1166379e-08 -0.099483608 -0.099483608 -0.099483608 - 19630 1.963 0.70620122 0.70619981 -2.4233094e-09 -0.099485163 -0.099485163 -0.099485163 - 19640 1.964 0.70620396 0.70620256 -1.6208717e-08 -0.099486713 -0.099486713 -0.099486713 - 19650 1.965 0.70620669 0.7062053 -2.9872943e-08 -0.099488259 -0.099488259 -0.099488259 - 19660 1.966 0.70620942 0.70620803 -4.3102813e-08 -0.0994898 -0.0994898 -0.0994898 - 19670 1.967 0.70621214 0.70621075 -5.5596058e-08 -0.099491336 -0.099491336 -0.099491336 - 19680 1.968 0.70621484 0.70621347 -6.7068215e-08 -0.099492868 -0.099492868 -0.099492868 - 19690 1.969 0.70621754 0.70621617 -7.7259102e-08 -0.099494395 -0.099494395 -0.099494395 - 19700 1.97 0.70622022 0.70621888 -8.5938718e-08 -0.099495918 -0.099495918 -0.099495918 - 19710 1.971 0.7062229 0.70622157 -9.2912428e-08 -0.099497436 -0.099497436 -0.099497436 - 19720 1.972 0.70622557 0.70622426 -9.8025326e-08 -0.099498949 -0.099498949 -0.099498949 - 19730 1.973 0.70622823 0.70622694 -1.0116567e-07 -0.099500458 -0.099500458 -0.099500458 - 19740 1.974 0.70623089 0.70622961 -1.0226731e-07 -0.099501962 -0.099501962 -0.099501962 - 19750 1.975 0.70623353 0.70623228 -1.0131109e-07 -0.099503461 -0.099503461 -0.099503461 - 19760 1.976 0.70623617 0.70623493 -9.8325127e-08 -0.099504956 -0.099504956 -0.099504956 - 19770 1.977 0.7062388 0.70623758 -9.3384031e-08 -0.099506447 -0.099506447 -0.099506447 - 19780 1.978 0.70624142 0.70624022 -8.660706e-08 -0.099507933 -0.099507933 -0.099507933 - 19790 1.979 0.70624404 0.70624285 -7.8155241e-08 -0.099509415 -0.099509415 -0.099509415 - 19800 1.98 0.70624664 0.70624547 -6.8227557e-08 -0.099510892 -0.099510892 -0.099510892 - 19810 1.981 0.70624924 0.70624808 -5.7056261e-08 -0.099512365 -0.099512365 -0.099512365 - 19820 1.982 0.70625184 0.70625068 -4.4901454e-08 -0.099513833 -0.099513833 -0.099513833 - 19830 1.983 0.70625443 0.70625328 -3.2045025e-08 -0.099515297 -0.099515297 -0.099515297 - 19840 1.984 0.70625701 0.70625586 -1.8784125e-08 -0.099516756 -0.099516756 -0.099516756 - 19850 1.985 0.70625958 0.70625844 -5.4242937e-09 -0.099518211 -0.099518211 -0.099518211 - 19860 1.986 0.70626215 0.706261 7.7275713e-09 -0.099519662 -0.099519662 -0.099519662 - 19870 1.987 0.70626472 0.70626356 2.0370265e-08 -0.099521108 -0.099521108 -0.099521108 - 19880 1.988 0.70626727 0.70626611 3.2215168e-08 -0.09952255 -0.09952255 -0.09952255 - 19890 1.989 0.70626982 0.70626864 4.2992837e-08 -0.099523987 -0.099523987 -0.099523987 - 19900 1.99 0.70627237 0.70627117 5.2459126e-08 -0.09952542 -0.09952542 -0.09952542 - 19910 1.991 0.7062749 0.7062737 6.0400718e-08 -0.099526849 -0.099526849 -0.099526849 - 19920 1.992 0.70627743 0.70627621 6.6639927e-08 -0.099528273 -0.099528273 -0.099528273 - 19930 1.993 0.70627995 0.70627871 7.1038669e-08 -0.099529694 -0.099529694 -0.099529694 - 19940 1.994 0.70628247 0.70628121 7.3501515e-08 -0.09953111 -0.09953111 -0.09953111 - 19950 1.995 0.70628498 0.7062837 7.3977751e-08 -0.099532521 -0.099532521 -0.099532521 - 19960 1.996 0.70628748 0.70628618 7.246241e-08 -0.099533929 -0.099533929 -0.099533929 - 19970 1.997 0.70628997 0.70628865 6.8996248e-08 -0.099535332 -0.099535332 -0.099535332 - 19980 1.998 0.70629245 0.70629112 6.3664676e-08 -0.099536731 -0.099536731 -0.099536731 - 19990 1.999 0.70629493 0.70629358 5.6595659e-08 -0.099538125 -0.099538125 -0.099538125 - 20000 2 0.7062974 0.70629604 4.7956659e-08 -0.099539516 -0.099539516 -0.099539516 - 20010 2.001 0.70629986 0.70629848 3.7950669e-08 -0.099540902 -0.099540902 -0.099540902 - 20020 2.002 0.70630231 0.70630093 2.681145e-08 -0.099542284 -0.099542284 -0.099542284 - 20030 2.003 0.70630475 0.70630336 1.479807e-08 -0.099543662 -0.099543662 -0.099543662 - 20040 2.004 0.70630718 0.70630579 2.1888892e-09 -0.099545036 -0.099545036 -0.099545036 - 20050 2.005 0.70630961 0.70630821 -1.0724895e-08 -0.099546405 -0.099546405 -0.099546405 - 20060 2.006 0.70631202 0.70631063 -2.3645964e-08 -0.099547771 -0.099547771 -0.099547771 - 20070 2.007 0.70631443 0.70631304 -3.6277725e-08 -0.099549132 -0.099549132 -0.099549132 - 20080 2.008 0.70631683 0.70631545 -4.8331111e-08 -0.099550489 -0.099550489 -0.099550489 - 20090 2.009 0.70631922 0.70631785 -5.95312e-08 -0.099551842 -0.099551842 -0.099551842 - 20100 2.01 0.7063216 0.70632024 -6.9623478e-08 -0.099553191 -0.099553191 -0.099553191 - 20110 2.011 0.70632397 0.70632263 -7.8379623e-08 -0.099554536 -0.099554536 -0.099554536 - 20120 2.012 0.70632634 0.70632501 -8.5602665e-08 -0.099555877 -0.099555877 -0.099555877 - 20130 2.013 0.7063287 0.70632738 -9.1131414e-08 -0.099557214 -0.099557214 -0.099557214 - 20140 2.014 0.70633105 0.70632975 -9.4844056e-08 -0.099558547 -0.099558547 -0.099558547 - 20150 2.015 0.70633339 0.70633211 -9.6660828e-08 -0.099559875 -0.099559875 -0.099559875 - 20160 2.016 0.70633573 0.70633446 -9.6545724e-08 -0.0995612 -0.0995612 -0.0995612 - 20170 2.017 0.70633805 0.70633681 -9.4507189e-08 -0.099562521 -0.099562521 -0.099562521 - 20180 2.018 0.70634038 0.70633915 -9.0597798e-08 -0.099563838 -0.099563838 -0.099563838 - 20190 2.019 0.70634269 0.70634148 -8.4912909e-08 -0.09956515 -0.09956515 -0.09956515 - 20200 2.02 0.706345 0.7063438 -7.7588353e-08 -0.099566459 -0.099566459 -0.099566459 - 20210 2.021 0.7063473 0.70634612 -6.8797191e-08 -0.099567764 -0.099567764 -0.099567764 - 20220 2.022 0.7063496 0.70634842 -5.8745631e-08 -0.099569065 -0.099569065 -0.099569065 - 20230 2.023 0.70635189 0.70635072 -4.7668196e-08 -0.099570362 -0.099570362 -0.099570362 - 20240 2.024 0.70635418 0.70635302 -3.5822255e-08 -0.099571655 -0.099571655 -0.099571655 - 20250 2.025 0.70635646 0.7063553 -2.3482047e-08 -0.099572944 -0.099572944 -0.099572944 - 20260 2.026 0.70635873 0.70635757 -1.0932334e-08 -0.09957423 -0.09957423 -0.09957423 - 20270 2.027 0.706361 0.70635984 1.5381658e-09 -0.099575511 -0.099575511 -0.099575511 - 20280 2.028 0.70636326 0.7063621 1.3643418e-08 -0.099576788 -0.099576788 -0.099576788 - 20290 2.029 0.70636552 0.70636435 2.5106632e-08 -0.099578062 -0.099578062 -0.099578062 - 20300 2.03 0.70636777 0.70636659 3.5666585e-08 -0.099579332 -0.099579332 -0.099579332 - 20310 2.031 0.70637002 0.70636883 4.5083572e-08 -0.099580598 -0.099580598 -0.099580598 - 20320 2.032 0.70637226 0.70637105 5.3144849e-08 -0.09958186 -0.09958186 -0.09958186 - 20330 2.033 0.70637449 0.70637327 5.9669428e-08 -0.099583118 -0.099583118 -0.099583118 - 20340 2.034 0.70637672 0.70637548 6.4512146e-08 -0.099584373 -0.099584373 -0.099584373 - 20350 2.035 0.70637894 0.70637769 6.7566882e-08 -0.099585624 -0.099585624 -0.099585624 - 20360 2.036 0.70638116 0.70637989 6.8768883e-08 -0.099586871 -0.099586871 -0.099586871 - 20370 2.037 0.70638337 0.70638208 6.8096123e-08 -0.099588114 -0.099588114 -0.099588114 - 20380 2.038 0.70638557 0.70638426 6.5569679e-08 -0.099589353 -0.099589353 -0.099589353 - 20390 2.039 0.70638776 0.70638644 6.1253126e-08 -0.099590589 -0.099590589 -0.099590589 - 20400 2.04 0.70638995 0.70638861 5.5250939e-08 -0.099591821 -0.099591821 -0.099591821 - 20410 2.041 0.70639213 0.70639078 4.7705984e-08 -0.099593049 -0.099593049 -0.099593049 - 20420 2.042 0.7063943 0.70639294 3.8796111e-08 -0.099594274 -0.099594274 -0.099594274 - 20430 2.043 0.70639647 0.7063951 2.8729978e-08 -0.099595495 -0.099595495 -0.099595495 - 20440 2.044 0.70639863 0.70639725 1.7742159e-08 -0.099596712 -0.099596712 -0.099596712 - 20450 2.045 0.70640078 0.70639939 6.0876855e-09 -0.099597925 -0.099597925 -0.099597925 - 20460 2.046 0.70640292 0.70640153 -5.9638709e-09 -0.099599135 -0.099599135 -0.099599135 - 20470 2.047 0.70640505 0.70640367 -1.8134631e-08 -0.099600341 -0.099600341 -0.099600341 - 20480 2.048 0.70640718 0.7064058 -3.0144812e-08 -0.099601544 -0.099601544 -0.099601544 - 20490 2.049 0.7064093 0.70640792 -4.1719159e-08 -0.099602742 -0.099602742 -0.099602742 - 20500 2.05 0.70641141 0.70641004 -5.2593248e-08 -0.099603938 -0.099603938 -0.099603938 - 20510 2.051 0.70641351 0.70641215 -6.2519525e-08 -0.099605129 -0.099605129 -0.099605129 - 20520 2.052 0.70641561 0.70641426 -7.1272944e-08 -0.099606317 -0.099606317 -0.099606317 - 20530 2.053 0.7064177 0.70641636 -7.8656058e-08 -0.099607502 -0.099607502 -0.099607502 - 20540 2.054 0.70641978 0.70641846 -8.4503476e-08 -0.099608683 -0.099608683 -0.099608683 - 20550 2.055 0.70642186 0.70642055 -8.8685564e-08 -0.09960986 -0.09960986 -0.09960986 - 20560 2.056 0.70642393 0.70642264 -9.1111311e-08 -0.099611034 -0.099611034 -0.099611034 - 20570 2.057 0.70642599 0.70642472 -9.1730305e-08 -0.099612204 -0.099612204 -0.099612204 - 20580 2.058 0.70642804 0.70642679 -9.0533768e-08 -0.09961337 -0.09961337 -0.09961337 - 20590 2.059 0.70643009 0.70642885 -8.7554636e-08 -0.099614534 -0.099614534 -0.099614534 - 20600 2.06 0.70643214 0.70643091 -8.2866671e-08 -0.099615693 -0.099615693 -0.099615693 - 20610 2.061 0.70643418 0.70643297 -7.6582653e-08 -0.099616849 -0.099616849 -0.099616849 - 20620 2.062 0.70643621 0.70643501 -6.8851668e-08 -0.099618002 -0.099618002 -0.099618002 - 20630 2.063 0.70643824 0.70643705 -5.9855578e-08 -0.099619151 -0.099619151 -0.099619151 - 20640 2.064 0.70644026 0.70643908 -4.9804747e-08 -0.099620297 -0.099620297 -0.099620297 - 20650 2.065 0.70644228 0.70644111 -3.8933125e-08 -0.099621439 -0.099621439 -0.099621439 - 20660 2.066 0.70644429 0.70644312 -2.7492808e-08 -0.099622578 -0.099622578 -0.099622578 - 20670 2.067 0.7064463 0.70644513 -1.5748189e-08 -0.099623713 -0.099623713 -0.099623713 - 20680 2.068 0.7064483 0.70644714 -3.969858e-09 -0.099624845 -0.099624845 -0.099624845 - 20690 2.069 0.7064503 0.70644913 7.5716351e-09 -0.099625973 -0.099625973 -0.099625973 - 20700 2.07 0.70645229 0.70645112 1.8611991e-08 -0.099627098 -0.099627098 -0.099627098 - 20710 2.071 0.70645428 0.7064531 2.889921e-08 -0.09962822 -0.09962822 -0.09962822 - 20720 2.072 0.70645627 0.70645507 3.8199345e-08 -0.099629338 -0.099629338 -0.099629338 - 20730 2.073 0.70645824 0.70645704 4.6301814e-08 -0.099630453 -0.099630453 -0.099630453 - 20740 2.074 0.70646022 0.706459 5.3024171e-08 -0.099631564 -0.099631564 -0.099631564 - 20750 2.075 0.70646219 0.70646095 5.8216207e-08 -0.099632672 -0.099632672 -0.099632672 - 20760 2.076 0.70646415 0.7064629 6.1763304e-08 -0.099633777 -0.099633777 -0.099633777 - 20770 2.077 0.70646611 0.70646484 6.3588961e-08 -0.099634879 -0.099634879 -0.099634879 - 20780 2.078 0.70646806 0.70646678 6.3656436e-08 -0.099635977 -0.099635977 -0.099635977 - 20790 2.079 0.70647 0.70646871 6.1969469e-08 -0.099637072 -0.099637072 -0.099637072 - 20800 2.08 0.70647194 0.70647063 5.8572077e-08 -0.099638163 -0.099638163 -0.099638163 - 20810 2.081 0.70647387 0.70647255 5.354742e-08 -0.099639251 -0.099639251 -0.099639251 - 20820 2.082 0.7064758 0.70647446 4.7015777e-08 -0.099640336 -0.099640336 -0.099640336 - 20830 2.083 0.70647772 0.70647637 3.9131669e-08 -0.099641418 -0.099641418 -0.099641418 - 20840 2.084 0.70647963 0.70647827 3.0080213e-08 -0.099642496 -0.099642496 -0.099642496 - 20850 2.085 0.70648154 0.70648017 2.0072773e-08 -0.099643571 -0.099643571 -0.099643571 - 20860 2.086 0.70648344 0.70648206 9.3420337e-09 -0.099644643 -0.099644643 -0.099644643 - 20870 2.087 0.70648533 0.70648395 -1.8634114e-09 -0.099645712 -0.099645712 -0.099645712 - 20880 2.088 0.70648722 0.70648584 -1.3284814e-08 -0.099646777 -0.099646777 -0.099646777 - 20890 2.089 0.7064891 0.70648772 -2.4659244e-08 -0.099647839 -0.099647839 -0.099647839 - 20900 2.09 0.70649097 0.70648959 -3.5725639e-08 -0.099648898 -0.099648898 -0.099648898 - 20910 2.091 0.70649283 0.70649146 -4.6230798e-08 -0.099649954 -0.099649954 -0.099649954 - 20920 2.092 0.70649469 0.70649333 -5.5935165e-08 -0.099651006 -0.099651006 -0.099651006 - 20930 2.093 0.70649654 0.70649519 -6.4618297e-08 -0.099652056 -0.099652056 -0.099652056 - 20940 2.094 0.70649839 0.70649705 -7.2083863e-08 -0.099653102 -0.099653102 -0.099653102 - 20950 2.095 0.70650023 0.7064989 -7.8164087e-08 -0.099654145 -0.099654145 -0.099654145 - 20960 2.096 0.70650206 0.70650075 -8.2723507e-08 -0.099655185 -0.099655185 -0.099655185 - 20970 2.097 0.70650388 0.70650259 -8.5661997e-08 -0.099656221 -0.099656221 -0.099656221 - 20980 2.098 0.7065057 0.70650443 -8.6916954e-08 -0.099657255 -0.099657255 -0.099657255 - 20990 2.099 0.70650752 0.70650626 -8.6464627e-08 -0.099658285 -0.099658285 -0.099658285 - 21000 2.1 0.70650933 0.70650808 -8.4320545e-08 -0.099659313 -0.099659313 -0.099659313 - 21010 2.101 0.70651113 0.7065099 -8.0539042e-08 -0.099660337 -0.099660337 -0.099660337 - 21020 2.102 0.70651293 0.70651172 -7.5211894e-08 -0.099661358 -0.099661358 -0.099661358 - 21030 2.103 0.70651473 0.70651352 -6.8466096e-08 -0.099662376 -0.099662376 -0.099662376 - 21040 2.104 0.70651652 0.70651533 -6.0460842e-08 -0.099663391 -0.099663391 -0.099663391 - 21050 2.105 0.70651831 0.70651712 -5.1383775e-08 -0.099664403 -0.099664403 -0.099664403 - 21060 2.106 0.70652009 0.70651891 -4.1446585e-08 -0.099665412 -0.099665412 -0.099665412 - 21070 2.107 0.70652186 0.70652069 -3.0880082e-08 -0.099666418 -0.099666418 -0.099666418 - 21080 2.108 0.70652364 0.70652247 -1.9928835e-08 -0.099667421 -0.099667421 -0.099667421 - 21090 2.109 0.70652541 0.70652423 -8.845512e-09 -0.09966842 -0.09966842 -0.09966842 - 21100 2.11 0.70652717 0.706526 2.1149427e-09 -0.099669417 -0.099669417 -0.099669417 - 21110 2.111 0.70652893 0.70652775 1.2701175e-08 -0.099670411 -0.099670411 -0.099670411 - 21120 2.112 0.70653069 0.7065295 2.267118e-08 -0.099671401 -0.099671401 -0.099671401 - 21130 2.113 0.70653244 0.70653125 3.1797835e-08 -0.099672389 -0.099672389 -0.099672389 - 21140 2.114 0.70653419 0.70653298 3.9874067e-08 -0.099673374 -0.099673374 -0.099673374 - 21150 2.115 0.70653593 0.70653471 4.6717553e-08 -0.099674355 -0.099674355 -0.099674355 - 21160 2.116 0.70653767 0.70653644 5.2174829e-08 -0.099675334 -0.099675334 -0.099675334 - 21170 2.117 0.7065394 0.70653816 5.6124731e-08 -0.09967631 -0.09967631 -0.09967631 - 21180 2.118 0.70654113 0.70653987 5.848108e-08 -0.099677283 -0.099677283 -0.099677283 - 21190 2.119 0.70654285 0.70654158 5.9194556e-08 -0.099678253 -0.099678253 -0.099678253 - 21200 2.12 0.70654457 0.70654328 5.825372e-08 -0.09967922 -0.09967922 -0.09967922 - 21210 2.121 0.70654628 0.70654498 5.5685163e-08 -0.099680184 -0.099680184 -0.099680184 - 21220 2.122 0.70654799 0.70654667 5.1552781e-08 -0.099681145 -0.099681145 -0.099681145 - 21230 2.123 0.70654969 0.70654836 4.5956196e-08 -0.099682103 -0.099682103 -0.099682103 - 21240 2.124 0.70655139 0.70655005 3.9028362e-08 -0.099683058 -0.099683058 -0.099683058 - 21250 2.125 0.70655308 0.70655173 3.0932406e-08 -0.099684011 -0.099684011 -0.099684011 - 21260 2.126 0.70655476 0.7065534 2.1857798e-08 -0.09968496 -0.09968496 -0.09968496 - 21270 2.127 0.70655644 0.70655507 1.2015912e-08 -0.099685907 -0.099685907 -0.099685907 - 21280 2.128 0.70655811 0.70655674 1.6351138e-09 -0.099686851 -0.099686851 -0.099686851 - 21290 2.129 0.70655978 0.70655841 -9.0445433e-09 -0.099687792 -0.099687792 -0.099687792 - 21300 2.13 0.70656144 0.70656007 -1.9776862e-08 -0.09968873 -0.09968873 -0.09968873 - 21310 2.131 0.70656309 0.70656172 -3.0315175e-08 -0.099689665 -0.099689665 -0.099689665 - 21320 2.132 0.70656474 0.70656337 -4.0418016e-08 -0.099690598 -0.099690598 -0.099690598 - 21330 2.133 0.70656638 0.70656502 -4.9854645e-08 -0.099691527 -0.099691527 -0.099691527 - 21340 2.134 0.70656802 0.70656667 -5.841032e-08 -0.099692454 -0.099692454 -0.099692454 - 21350 2.135 0.70656965 0.70656831 -6.5891177e-08 -0.099693378 -0.099693378 -0.099693378 - 21360 2.136 0.70657127 0.70656994 -7.2128628e-08 -0.099694299 -0.099694299 -0.099694299 - 21370 2.137 0.70657289 0.70657157 -7.6983148e-08 -0.099695218 -0.099695218 -0.099695218 - 21380 2.138 0.7065745 0.7065732 -8.03474e-08 -0.099696133 -0.099696133 -0.099696133 - 21390 2.139 0.70657611 0.70657482 -8.2148598e-08 -0.099697046 -0.099697046 -0.099697046 - 21400 2.14 0.70657771 0.70657644 -8.2350082e-08 -0.099697956 -0.099697956 -0.099697956 - 21410 2.141 0.70657931 0.70657805 -8.0952044e-08 -0.099698864 -0.099698864 -0.099698864 - 21420 2.142 0.7065809 0.70657966 -7.7991418e-08 -0.099699768 -0.099699768 -0.099699768 - 21430 2.143 0.70658249 0.70658126 -7.3540919e-08 -0.09970067 -0.09970067 -0.09970067 - 21440 2.144 0.70658407 0.70658286 -6.7707267e-08 -0.099701569 -0.099701569 -0.099701569 - 21450 2.145 0.70658566 0.70658445 -6.062863e-08 -0.099702466 -0.099702466 -0.099702466 - 21460 2.146 0.70658723 0.70658604 -5.247136e-08 -0.09970336 -0.09970336 -0.09970336 - 21470 2.147 0.7065888 0.70658762 -4.3426085e-08 -0.099704251 -0.099704251 -0.099704251 - 21480 2.148 0.70659037 0.70658919 -3.3703257e-08 -0.099705139 -0.099705139 -0.099705139 - 21490 2.149 0.70659194 0.70659076 -2.3528257e-08 -0.099706025 -0.099706025 -0.099706025 - 21500 2.15 0.7065935 0.70659232 -1.3136176e-08 -0.099706908 -0.099706908 -0.099706908 - 21510 2.151 0.70659506 0.70659388 -2.7663851e-09 -0.099707788 -0.099707788 -0.099707788 - 21520 2.152 0.70659661 0.70659543 7.3429794e-09 -0.099708665 -0.099708665 -0.099708665 - 21530 2.153 0.70659816 0.70659698 1.6960479e-08 -0.09970954 -0.09970954 -0.09970954 - 21540 2.154 0.70659971 0.70659852 2.5866671e-08 -0.099710413 -0.099710413 -0.099710413 - 21550 2.155 0.70660125 0.70660005 3.3859113e-08 -0.099711282 -0.099711282 -0.099711282 - 21560 2.156 0.70660279 0.70660158 4.075696e-08 -0.09971215 -0.09971215 -0.09971215 - 21570 2.157 0.70660433 0.7066031 4.6405059e-08 -0.099713014 -0.099713014 -0.099713014 - 21580 2.158 0.70660586 0.70660462 5.0677431e-08 -0.099713876 -0.099713876 -0.099713876 - 21590 2.159 0.70660739 0.70660613 5.3480079e-08 -0.099714735 -0.099714735 -0.099714735 - 21600 2.16 0.70660891 0.70660764 5.4753051e-08 -0.099715592 -0.099715592 -0.099715592 - 21610 2.161 0.70661043 0.70660914 5.4471716e-08 -0.099716446 -0.099716446 -0.099716446 - 21620 2.162 0.70661194 0.70661064 5.2647221e-08 -0.099717297 -0.099717297 -0.099717297 - 21630 2.163 0.70661345 0.70661214 4.9326131e-08 -0.099718146 -0.099718146 -0.099718146 - 21640 2.164 0.70661495 0.70661363 4.4589249e-08 -0.099718992 -0.099718992 -0.099718992 - 21650 2.165 0.70661645 0.70661511 3.8549661e-08 -0.099719836 -0.099719836 -0.099719836 - 21660 2.166 0.70661794 0.7066166 3.1350035e-08 -0.099720677 -0.099720677 -0.099720677 - 21670 2.167 0.70661943 0.70661808 2.3159262e-08 -0.099721516 -0.099721516 -0.099721516 - 21680 2.168 0.70662091 0.70661955 1.4168493e-08 -0.099722352 -0.099722352 -0.099722352 - 21690 2.169 0.70662239 0.70662103 4.5866794e-09 -0.099723185 -0.099723185 -0.099723185 - 21700 2.17 0.70662386 0.70662249 -5.3642766e-09 -0.099724016 -0.099724016 -0.099724016 - 21710 2.171 0.70662533 0.70662396 -1.5454661e-08 -0.099724845 -0.099724845 -0.099724845 - 21720 2.172 0.70662679 0.70662542 -2.545225e-08 -0.099725671 -0.099725671 -0.099725671 - 21730 2.173 0.70662824 0.70662688 -3.5127648e-08 -0.099726495 -0.099726495 -0.099726495 - 21740 2.174 0.70662969 0.70662834 -4.4259555e-08 -0.099727316 -0.099727316 -0.099727316 - 21750 2.175 0.70663114 0.70662979 -5.263982e-08 -0.099728134 -0.099728134 -0.099728134 - 21760 2.176 0.70663258 0.70663124 -6.007819e-08 -0.09972895 -0.09972895 -0.09972895 - 21770 2.177 0.70663401 0.70663268 -6.640662e-08 -0.099729764 -0.099729764 -0.099729764 - 21780 2.178 0.70663544 0.70663412 -7.1483074e-08 -0.099730575 -0.099730575 -0.099730575 - 21790 2.179 0.70663686 0.70663556 -7.5194702e-08 -0.099731384 -0.099731384 -0.099731384 - 21800 2.18 0.70663828 0.70663699 -7.7460351e-08 -0.09973219 -0.09973219 -0.09973219 - 21810 2.181 0.7066397 0.70663842 -7.8232334e-08 -0.099732994 -0.099732994 -0.099732994 - 21820 2.182 0.70664111 0.70663985 -7.7497419e-08 -0.099733795 -0.099733795 -0.099733795 - 21830 2.183 0.70664251 0.70664127 -7.5277035e-08 -0.099734594 -0.099734594 -0.099734594 - 21840 2.184 0.70664392 0.70664268 -7.1626675e-08 -0.099735391 -0.099735391 -0.099735391 - 21850 2.185 0.70664531 0.70664409 -6.6634516e-08 -0.099736185 -0.099736185 -0.099736185 - 21860 2.186 0.70664671 0.7066455 -6.0419295e-08 -0.099736976 -0.099736976 -0.099736976 - 21870 2.187 0.7066481 0.7066469 -5.3127493e-08 -0.099737766 -0.099737766 -0.099737766 - 21880 2.188 0.70664949 0.70664829 -4.4929882e-08 -0.099738553 -0.099738553 -0.099738553 - 21890 2.189 0.70665087 0.70664969 -3.6017529e-08 -0.099739337 -0.099739337 -0.099739337 - 21900 2.19 0.70665226 0.70665107 -2.6597349e-08 -0.099740119 -0.099740119 -0.099740119 - 21910 2.191 0.70665363 0.70665245 -1.6887299e-08 -0.099740899 -0.099740899 -0.099740899 - 21920 2.192 0.70665501 0.70665383 -7.1113393e-09 -0.099741677 -0.099741677 -0.099741677 - 21930 2.193 0.70665638 0.7066552 2.5057297e-09 -0.099742452 -0.099742452 -0.099742452 - 21940 2.194 0.70665775 0.70665656 1.1743436e-08 -0.099743224 -0.099743224 -0.099743224 - 21950 2.195 0.70665912 0.70665792 2.0390686e-08 -0.099743995 -0.099743995 -0.099743995 - 21960 2.196 0.70666048 0.70665928 2.8250591e-08 -0.099744763 -0.099744763 -0.099744763 - 21970 2.197 0.70666184 0.70666063 3.5144941e-08 -0.099745529 -0.099745529 -0.099745529 - 21980 2.198 0.7066632 0.70666197 4.0918251e-08 -0.099746292 -0.099746292 -0.099746292 - 21990 2.199 0.70666455 0.70666331 4.5441257e-08 -0.099747053 -0.099747053 -0.099747053 - 22000 2.2 0.7066659 0.70666465 4.8613813e-08 -0.099747812 -0.099747812 -0.099747812 - 22010 2.201 0.70666724 0.70666598 5.0367102e-08 -0.099748569 -0.099748569 -0.099748569 - 22020 2.202 0.70666858 0.70666731 5.0665122e-08 -0.099749323 -0.099749323 -0.099749323 - 22030 2.203 0.70666992 0.70666863 4.9505415e-08 -0.099750075 -0.099750075 -0.099750075 - 22040 2.204 0.70667125 0.70666995 4.6919025e-08 -0.099750825 -0.099750825 -0.099750825 - 22050 2.205 0.70667258 0.70667126 4.2969679e-08 -0.099751572 -0.099751572 -0.099751572 - 22060 2.206 0.7066739 0.70667258 3.7752229e-08 -0.099752317 -0.099752317 -0.099752317 - 22070 2.207 0.70667522 0.70667389 3.1390377e-08 -0.09975306 -0.09975306 -0.09975306 - 22080 2.208 0.70667654 0.70667519 2.4033745e-08 -0.099753801 -0.099753801 -0.099753801 - 22090 2.209 0.70667785 0.70667649 1.5854363e-08 -0.099754539 -0.099754539 -0.099754539 - 22100 2.21 0.70667915 0.70667779 7.0426432e-09 -0.099755275 -0.099755275 -0.099755275 - 22110 2.211 0.70668045 0.70667909 -2.1970451e-09 -0.099756009 -0.099756009 -0.099756009 - 22120 2.212 0.70668175 0.70668038 -1.1651116e-08 -0.099756741 -0.099756741 -0.099756741 - 22130 2.213 0.70668304 0.70668168 -2.1101702e-08 -0.09975747 -0.09975747 -0.09975747 - 22140 2.214 0.70668432 0.70668296 -3.0331671e-08 -0.099758198 -0.099758198 -0.099758198 - 22150 2.215 0.7066856 0.70668425 -3.9129616e-08 -0.099758923 -0.099758923 -0.099758923 - 22160 2.216 0.70668688 0.70668553 -4.7294692e-08 -0.099759646 -0.099759646 -0.099759646 - 22170 2.217 0.70668815 0.70668681 -5.4641202e-08 -0.099760366 -0.099760366 -0.099760366 - 22180 2.218 0.70668941 0.70668809 -6.1002816e-08 -0.099761085 -0.099761085 -0.099761085 - 22190 2.219 0.70669068 0.70668936 -6.6236337e-08 -0.099761801 -0.099761801 -0.099761801 - 22200 2.22 0.70669193 0.70669063 -7.0224917e-08 -0.099762515 -0.099762515 -0.099762515 - 22210 2.221 0.70669319 0.70669189 -7.2880669e-08 -0.099763227 -0.099763227 -0.099763227 - 22220 2.222 0.70669444 0.70669316 -7.4146593e-08 -0.099763937 -0.099763937 -0.099763937 - 22230 2.223 0.70669568 0.70669441 -7.3997797e-08 -0.099764645 -0.099764645 -0.099764645 - 22240 2.224 0.70669692 0.70669567 -7.2441969e-08 -0.099765351 -0.099765351 -0.099765351 - 22250 2.225 0.70669816 0.70669692 -6.9519106e-08 -0.099766054 -0.099766054 -0.099766054 - 22260 2.226 0.7066994 0.70669817 -6.5300494e-08 -0.099766755 -0.099766755 -0.099766755 - 22270 2.227 0.70670063 0.70669941 -5.9886979e-08 -0.099767455 -0.099767455 -0.099767455 - 22280 2.228 0.70670185 0.70670064 -5.3406557e-08 -0.099768152 -0.099768152 -0.099768152 - 22290 2.229 0.70670308 0.70670188 -4.6011356e-08 -0.099768847 -0.099768847 -0.099768847 - 22300 2.23 0.7067043 0.70670311 -3.7874064e-08 -0.09976954 -0.09976954 -0.09976954 - 22310 2.231 0.70670552 0.70670433 -2.9183898e-08 -0.09977023 -0.09977023 -0.09977023 - 22320 2.232 0.70670674 0.70670555 -2.0142212e-08 -0.099770919 -0.099770919 -0.099770919 - 22330 2.233 0.70670795 0.70670676 -1.0957829e-08 -0.099771606 -0.099771606 -0.099771606 - 22340 2.234 0.70670916 0.70670797 -1.8422197e-09 -0.09977229 -0.09977229 -0.09977229 - 22350 2.235 0.70671037 0.70670918 6.9953612e-09 -0.099772972 -0.099772972 -0.099772972 - 22360 2.236 0.70671158 0.70671038 1.5352679e-08 -0.099773653 -0.099773653 -0.099773653 - 22370 2.237 0.70671278 0.70671158 2.3039146e-08 -0.099774331 -0.099774331 -0.099774331 - 22380 2.238 0.70671398 0.70671277 2.9880161e-08 -0.099775007 -0.099775007 -0.099775007 - 22390 2.239 0.70671518 0.70671396 3.572108e-08 -0.099775682 -0.099775682 -0.099775682 - 22400 2.24 0.70671638 0.70671514 4.0430705e-08 -0.099776354 -0.099776354 -0.099776354 - 22410 2.241 0.70671757 0.70671632 4.3904229e-08 -0.099777024 -0.099777024 -0.099777024 - 22420 2.242 0.70671875 0.7067175 4.6065566e-08 -0.099777692 -0.099777692 -0.099777692 - 22430 2.243 0.70671994 0.70671867 4.6869011e-08 -0.099778358 -0.099778358 -0.099778358 - 22440 2.244 0.70672112 0.70671984 4.6300201e-08 -0.099779022 -0.099779022 -0.099779022 - 22450 2.245 0.7067223 0.706721 4.4376349e-08 -0.099779684 -0.099779684 -0.099779684 - 22460 2.246 0.70672347 0.70672216 4.1145753e-08 -0.099780344 -0.099780344 -0.099780344 - 22470 2.247 0.70672464 0.70672332 3.6686596e-08 -0.099781002 -0.099781002 -0.099781002 - 22480 2.248 0.70672581 0.70672448 3.1105053e-08 -0.099781658 -0.099781658 -0.099781658 - 22490 2.249 0.70672697 0.70672563 2.4532774e-08 -0.099782313 -0.099782313 -0.099782313 - 22500 2.25 0.70672812 0.70672678 1.7123777e-08 -0.099782965 -0.099782965 -0.099782965 - 22510 2.251 0.70672928 0.70672792 9.0508418e-09 -0.099783615 -0.099783615 -0.099783615 - 22520 2.252 0.70673042 0.70672907 5.0148589e-10 -0.099784263 -0.099784263 -0.099784263 - 22530 2.253 0.70673157 0.70673021 -8.3263915e-09 -0.099784909 -0.099784909 -0.099784909 - 22540 2.254 0.70673271 0.70673135 -1.7229088e-08 -0.099785553 -0.099785553 -0.099785553 - 22550 2.255 0.70673384 0.70673249 -2.6001795e-08 -0.099786196 -0.099786196 -0.099786196 - 22560 2.256 0.70673497 0.70673362 -3.444331e-08 -0.099786836 -0.099786836 -0.099786836 - 22570 2.257 0.7067361 0.70673475 -4.2360648e-08 -0.099787474 -0.099787474 -0.099787474 - 22580 2.258 0.70673722 0.70673588 -4.9573453e-08 -0.099788111 -0.099788111 -0.099788111 - 22590 2.259 0.70673834 0.70673701 -5.59181e-08 -0.099788745 -0.099788745 -0.099788745 - 22600 2.26 0.70673945 0.70673813 -6.125141e-08 -0.099789378 -0.099789378 -0.099789378 - 22610 2.261 0.70674056 0.70673926 -6.5453878e-08 -0.099790009 -0.099790009 -0.099790009 - 22620 2.262 0.70674167 0.70674037 -6.8432344e-08 -0.099790638 -0.099790638 -0.099790638 - 22630 2.263 0.70674277 0.70674149 -7.0122059e-08 -0.099791264 -0.099791264 -0.099791264 - 22640 2.264 0.70674387 0.7067426 -7.0488084e-08 -0.099791889 -0.099791889 -0.099791889 - 22650 2.265 0.70674497 0.70674371 -6.9526007e-08 -0.099792513 -0.099792513 -0.099792513 - 22660 2.266 0.70674606 0.70674481 -6.7261947e-08 -0.099793134 -0.099793134 -0.099793134 - 22670 2.267 0.70674715 0.70674591 -6.3751866e-08 -0.099793753 -0.099793753 -0.099793753 - 22680 2.268 0.70674824 0.70674701 -5.9080192e-08 -0.099794371 -0.099794371 -0.099794371 - 22690 2.269 0.70674932 0.70674811 -5.3357793e-08 -0.099794986 -0.099794986 -0.099794986 - 22700 2.27 0.7067504 0.70674919 -4.6719347e-08 -0.0997956 -0.0997956 -0.0997956 - 22710 2.271 0.70675148 0.70675028 -3.932018e-08 -0.099796212 -0.099796212 -0.099796212 - 22720 2.272 0.70675256 0.70675136 -3.133263e-08 -0.099796822 -0.099796822 -0.099796822 - 22730 2.273 0.70675363 0.70675244 -2.2942037e-08 -0.09979743 -0.09979743 -0.09979743 - 22740 2.274 0.70675471 0.70675351 -1.4342445e-08 -0.099798036 -0.099798036 -0.099798036 - 22750 2.275 0.70675578 0.70675458 -5.7321139e-09 -0.099798641 -0.099798641 -0.099798641 - 22760 2.276 0.70675684 0.70675565 2.6910464e-09 -0.099799243 -0.099799243 -0.099799243 - 22770 2.277 0.70675791 0.70675671 1.0734025e-08 -0.099799844 -0.099799844 -0.099799844 - 22780 2.278 0.70675897 0.70675776 1.8213131e-08 -0.099800443 -0.099800443 -0.099800443 - 22790 2.279 0.70676003 0.70675881 2.4958185e-08 -0.099801041 -0.099801041 -0.099801041 - 22800 2.28 0.70676109 0.70675986 3.0816393e-08 -0.099801636 -0.099801636 -0.099801636 - 22810 2.281 0.70676214 0.70676091 3.5655801e-08 -0.09980223 -0.09980223 -0.09980223 - 22820 2.282 0.70676319 0.70676195 3.9368268e-08 -0.099802821 -0.099802821 -0.099802821 - 22830 2.283 0.70676424 0.70676299 4.187188e-08 -0.099803411 -0.099803411 -0.099803411 - 22840 2.284 0.70676529 0.70676402 4.3112749e-08 -0.099804 -0.099804 -0.099804 - 22850 2.285 0.70676633 0.70676505 4.3066173e-08 -0.099804586 -0.099804586 -0.099804586 - 22860 2.286 0.70676737 0.70676608 4.1737109e-08 -0.099805171 -0.099805171 -0.099805171 - 22870 2.287 0.70676841 0.70676711 3.9159976e-08 -0.099805754 -0.099805754 -0.099805754 - 22880 2.288 0.70676944 0.70676813 3.5397772e-08 -0.099806335 -0.099806335 -0.099806335 - 22890 2.289 0.70677047 0.70676915 3.054054e-08 -0.099806914 -0.099806914 -0.099806914 - 22900 2.29 0.7067715 0.70677017 2.4703217e-08 -0.099807492 -0.099807492 -0.099807492 - 22910 2.291 0.70677252 0.70677118 1.802292e-08 -0.099808068 -0.099808068 -0.099808068 - 22920 2.292 0.70677354 0.70677219 1.0655723e-08 -0.099808642 -0.099808642 -0.099808642 - 22930 2.293 0.70677455 0.7067732 2.7730173e-09 -0.099809214 -0.099809214 -0.099809214 - 22940 2.294 0.70677556 0.70677421 -5.4424759e-09 -0.099809785 -0.099809785 -0.099809785 - 22950 2.295 0.70677657 0.70677522 -1.3800939e-08 -0.099810354 -0.099810354 -0.099810354 - 22960 2.296 0.70677757 0.70677622 -2.210984e-08 -0.099810921 -0.099810921 -0.099810921 - 22970 2.297 0.70677857 0.70677722 -3.0178368e-08 -0.099811486 -0.099811486 -0.099811486 - 22980 2.298 0.70677957 0.70677822 -3.7821814e-08 -0.09981205 -0.09981205 -0.09981205 - 22990 2.299 0.70678056 0.70677922 -4.4865793e-08 -0.099812612 -0.099812612 -0.099812612 - 23000 2.3 0.70678154 0.70678021 -5.1150227e-08 -0.099813172 -0.099813172 -0.099813172 - 23010 2.301 0.70678253 0.70678121 -5.6532976e-08 -0.099813731 -0.099813731 -0.099813731 - 23020 2.302 0.70678351 0.7067822 -6.0893052e-08 -0.099814288 -0.099814288 -0.099814288 - 23030 2.303 0.70678448 0.70678318 -6.4133338e-08 -0.099814843 -0.099814843 -0.099814843 - 23040 2.304 0.70678546 0.70678417 -6.6182745e-08 -0.099815397 -0.099815397 -0.099815397 - 23050 2.305 0.70678643 0.70678515 -6.6997771e-08 -0.099815949 -0.099815949 -0.099815949 - 23060 2.306 0.7067874 0.70678613 -6.6563413e-08 -0.099816499 -0.099816499 -0.099816499 - 23070 2.307 0.70678836 0.70678711 -6.4893431e-08 -0.099817048 -0.099817048 -0.099817048 - 23080 2.308 0.70678932 0.70678808 -6.2029939e-08 -0.099817595 -0.099817595 -0.099817595 - 23090 2.309 0.70679028 0.70678905 -5.8042357e-08 -0.09981814 -0.09981814 -0.09981814 - 23100 2.31 0.70679124 0.70679001 -5.3025731e-08 -0.099818684 -0.099818684 -0.099818684 - 23110 2.311 0.70679219 0.70679098 -4.7098472e-08 -0.099819226 -0.099819226 -0.099819226 - 23120 2.312 0.70679315 0.70679194 -4.039956e-08 -0.099819766 -0.099819766 -0.099819766 - 23130 2.313 0.7067941 0.70679289 -3.3085295e-08 -0.099820305 -0.099820305 -0.099820305 - 23140 2.314 0.70679504 0.70679384 -2.5325644e-08 -0.099820842 -0.099820842 -0.099820842 - 23150 2.315 0.70679599 0.70679479 -1.7300302e-08 -0.099821377 -0.099821377 -0.099821377 - 23160 2.316 0.70679693 0.70679573 -9.1945247e-09 -0.099821911 -0.099821911 -0.099821911 - 23170 2.317 0.70679788 0.70679667 -1.1948586e-09 -0.099822443 -0.099822443 -0.099822443 - 23180 2.318 0.70679882 0.70679761 6.5151521e-09 -0.099822974 -0.099822974 -0.099822974 - 23190 2.319 0.70679975 0.70679854 1.3759175e-08 -0.099823503 -0.099823503 -0.099823503 - 23200 2.32 0.70680069 0.70679947 2.037212e-08 -0.09982403 -0.09982403 -0.09982403 - 23210 2.321 0.70680162 0.7068004 2.6203901e-08 -0.099824556 -0.099824556 -0.099824556 - 23220 2.322 0.70680256 0.70680132 3.112284e-08 -0.09982508 -0.09982508 -0.09982508 - 23230 2.323 0.70680348 0.70680224 3.5018635e-08 -0.099825603 -0.099825603 -0.099825603 - 23240 2.324 0.70680441 0.70680316 3.7804836e-08 -0.099826124 -0.099826124 -0.099826124 - 23250 2.325 0.70680534 0.70680407 3.9420758e-08 -0.099826643 -0.099826643 -0.099826643 - 23260 2.326 0.70680626 0.70680498 3.9832795e-08 -0.099827161 -0.099827161 -0.099827161 - 23270 2.327 0.70680718 0.70680589 3.9035115e-08 -0.099827677 -0.099827677 -0.099827677 - 23280 2.328 0.70680809 0.70680679 3.7049709e-08 -0.099828192 -0.099828192 -0.099828192 - 23290 2.329 0.706809 0.7068077 3.3925798e-08 -0.099828705 -0.099828705 -0.099828705 - 23300 2.33 0.70680991 0.7068086 2.9738627e-08 -0.099829217 -0.099829217 -0.099829217 - 23310 2.331 0.70681082 0.70680949 2.4587649e-08 -0.099829727 -0.099829727 -0.099829727 - 23320 2.332 0.70681172 0.70681039 1.8594173e-08 -0.099830235 -0.099830235 -0.099830235 - 23330 2.333 0.70681262 0.70681128 1.1898502e-08 -0.099830742 -0.099830742 -0.099830742 - 23340 2.334 0.70681352 0.70681218 4.6566595e-09 -0.099831248 -0.099831248 -0.099831248 - 23350 2.335 0.70681441 0.70681306 -2.9632507e-09 -0.099831752 -0.099831752 -0.099831752 - 23360 2.336 0.7068153 0.70681395 -1.0784942e-08 -0.099832254 -0.099832254 -0.099832254 - 23370 2.337 0.70681619 0.70681484 -1.8628022e-08 -0.099832755 -0.099832755 -0.099832755 - 23380 2.338 0.70681707 0.70681572 -2.6312152e-08 -0.099833254 -0.099833254 -0.099833254 - 23390 2.339 0.70681795 0.70681661 -3.3661192e-08 -0.099833752 -0.099833752 -0.099833752 - 23400 2.34 0.70681882 0.70681749 -4.0507233e-08 -0.099834249 -0.099834249 -0.099834249 - 23410 2.341 0.70681969 0.70681836 -4.669444e-08 -0.099834743 -0.099834743 -0.099834743 - 23420 2.342 0.70682056 0.70681924 -5.2082587e-08 -0.099835237 -0.099835237 -0.099835237 - 23430 2.343 0.70682143 0.70682012 -5.6550242e-08 -0.099835729 -0.099835729 -0.099835729 - 23440 2.344 0.70682229 0.70682099 -5.9997496e-08 -0.099836219 -0.099836219 -0.099836219 - 23450 2.345 0.70682315 0.70682186 -6.2348197e-08 -0.099836708 -0.099836708 -0.099836708 - 23460 2.346 0.70682401 0.70682272 -6.3551627e-08 -0.099837195 -0.099837195 -0.099837195 - 23470 2.347 0.70682486 0.70682359 -6.3583594e-08 -0.099837681 -0.099837681 -0.099837681 - 23480 2.348 0.70682571 0.70682445 -6.2446904e-08 -0.099838165 -0.099838165 -0.099838165 - 23490 2.349 0.70682656 0.70682531 -6.0171218e-08 -0.099838648 -0.099838648 -0.099838648 - 23500 2.35 0.70682741 0.70682617 -5.6812289e-08 -0.09983913 -0.09983913 -0.09983913 - 23510 2.351 0.70682825 0.70682702 -5.2450599e-08 -0.09983961 -0.09983961 -0.09983961 - 23520 2.352 0.70682909 0.70682787 -4.7189438e-08 -0.099840089 -0.099840089 -0.099840089 - 23530 2.353 0.70682993 0.70682872 -4.115246e-08 -0.099840566 -0.099840566 -0.099840566 - 23540 2.354 0.70683077 0.70682956 -3.4480775e-08 -0.099841041 -0.099841041 -0.099841041 - 23550 2.355 0.70683161 0.7068304 -2.732966e-08 -0.099841516 -0.099841516 -0.099841516 - 23560 2.356 0.70683244 0.70683124 -1.9864941e-08 -0.099841988 -0.099841988 -0.099841988 - 23570 2.357 0.70683328 0.70683207 -1.2259152e-08 -0.09984246 -0.09984246 -0.09984246 - 23580 2.358 0.70683411 0.7068329 -4.6875496e-09 -0.09984293 -0.09984293 -0.09984293 - 23590 2.359 0.70683494 0.70683373 2.675926e-09 -0.099843398 -0.099843398 -0.099843398 - 23600 2.36 0.70683577 0.70683456 9.6626439e-09 -0.099843865 -0.099843865 -0.099843865 - 23610 2.361 0.70683659 0.70683538 1.6113143e-08 -0.099844331 -0.099844331 -0.099844331 - 23620 2.362 0.70683742 0.70683619 2.188077e-08 -0.099844795 -0.099844795 -0.099844795 - 23630 2.363 0.70683824 0.70683701 2.6835011e-08 -0.099845258 -0.099845258 -0.099845258 - 23640 2.364 0.70683906 0.70683782 3.0864443e-08 -0.09984572 -0.09984572 -0.09984572 - 23650 2.365 0.70683988 0.70683863 3.387924e-08 -0.09984618 -0.09984618 -0.09984618 - 23660 2.366 0.7068407 0.70683944 3.5813168e-08 -0.099846639 -0.099846639 -0.099846639 - 23670 2.367 0.70684151 0.70684024 3.6625041e-08 -0.099847096 -0.099847096 -0.099847096 - 23680 2.368 0.70684232 0.70684104 3.6299589e-08 -0.099847552 -0.099847552 -0.099847552 - 23690 2.369 0.70684313 0.70684184 3.484773e-08 -0.099848006 -0.099848006 -0.099848006 - 23700 2.37 0.70684394 0.70684263 3.2306245e-08 -0.099848459 -0.099848459 -0.099848459 - 23710 2.371 0.70684474 0.70684343 2.8736849e-08 -0.099848911 -0.099848911 -0.099848911 - 23720 2.372 0.70684554 0.70684422 2.42247e-08 -0.099849362 -0.099849362 -0.099849362 - 23730 2.373 0.70684634 0.70684501 1.8876368e-08 -0.099849811 -0.099849811 -0.099849811 - 23740 2.374 0.70684713 0.7068458 1.2817326e-08 -0.099850258 -0.099850258 -0.099850258 - 23750 2.375 0.70684793 0.70684659 6.1890013e-09 -0.099850705 -0.099850705 -0.099850705 - 23760 2.376 0.70684871 0.70684737 -8.5451703e-10 -0.09985115 -0.09985115 -0.09985115 - 23770 2.377 0.7068495 0.70684816 -8.1500628e-09 -0.099851593 -0.099851593 -0.099851593 - 23780 2.378 0.70685028 0.70684894 -1.5529169e-08 -0.099852036 -0.099852036 -0.099852036 - 23790 2.379 0.70685106 0.70684972 -2.2821957e-08 -0.099852477 -0.099852477 -0.099852477 - 23800 2.38 0.70685184 0.7068505 -2.9861045e-08 -0.099852916 -0.099852916 -0.099852916 - 23810 2.381 0.70685261 0.70685128 -3.6485391e-08 -0.099853355 -0.099853355 -0.099853355 - 23820 2.382 0.70685338 0.70685205 -4.254397e-08 -0.099853791 -0.099853791 -0.099853791 - 23830 2.383 0.70685415 0.70685283 -4.7899223e-08 -0.099854227 -0.099854227 -0.099854227 - 23840 2.384 0.70685491 0.7068536 -5.2430172e-08 -0.099854661 -0.099854661 -0.099854661 - 23850 2.385 0.70685567 0.70685437 -5.6035154e-08 -0.099855094 -0.099855094 -0.099855094 - 23860 2.386 0.70685643 0.70685514 -5.8634099e-08 -0.099855526 -0.099855526 -0.099855526 - 23870 2.387 0.70685719 0.7068559 -6.0170307e-08 -0.099855956 -0.099855956 -0.099855956 - 23880 2.388 0.70685794 0.70685667 -6.0611676e-08 -0.099856386 -0.099856386 -0.099856386 - 23890 2.389 0.70685869 0.70685743 -5.9951373e-08 -0.099856813 -0.099856813 -0.099856813 - 23900 2.39 0.70685944 0.70685819 -5.8207909e-08 -0.09985724 -0.09985724 -0.09985724 - 23910 2.391 0.70686019 0.70685894 -5.5424637e-08 -0.099857665 -0.099857665 -0.099857665 - 23920 2.392 0.70686093 0.7068597 -5.1668687e-08 -0.099858089 -0.099858089 -0.099858089 - 23930 2.393 0.70686168 0.70686045 -4.702934e-08 -0.099858511 -0.099858511 -0.099858511 - 23940 2.394 0.70686242 0.7068612 -4.1615921e-08 -0.099858933 -0.099858933 -0.099858933 - 23950 2.395 0.70686316 0.70686194 -3.5555213e-08 -0.099859353 -0.099859353 -0.099859353 - 23960 2.396 0.7068639 0.70686269 -2.8988501e-08 -0.099859772 -0.099859772 -0.099859772 - 23970 2.397 0.70686463 0.70686342 -2.2068273e-08 -0.099860189 -0.099860189 -0.099860189 - 23980 2.398 0.70686537 0.70686416 -1.4954682e-08 -0.099860605 -0.099860605 -0.099860605 - 23990 2.399 0.7068661 0.7068649 -7.8118434e-09 -0.09986102 -0.09986102 -0.09986102 - 24000 2.4 0.70686684 0.70686563 -8.0404842e-10 -0.099861434 -0.099861434 -0.099861434 - 24010 2.401 0.70686757 0.70686635 5.9080126e-09 -0.099861847 -0.099861847 -0.099861847 - 24020 2.402 0.7068683 0.70686708 1.2170934e-08 -0.099862258 -0.099862258 -0.099862258 - 24030 2.403 0.70686902 0.7068678 1.7842097e-08 -0.099862668 -0.099862668 -0.099862668 - 24040 2.404 0.70686975 0.70686852 2.2792921e-08 -0.099863077 -0.099863077 -0.099863077 - 24050 2.405 0.70687048 0.70686924 2.6911771e-08 -0.099863484 -0.099863484 -0.099863484 - 24060 2.406 0.7068712 0.70686995 3.0106476e-08 -0.09986389 -0.09986389 -0.09986389 - 24070 2.407 0.70687192 0.70687066 3.2306389e-08 -0.099864295 -0.099864295 -0.099864295 - 24080 2.408 0.70687264 0.70687137 3.3463945e-08 -0.099864699 -0.099864699 -0.099864699 - 24090 2.409 0.70687336 0.70687208 3.3555687e-08 -0.099865102 -0.099865102 -0.099865102 - 24100 2.41 0.70687407 0.70687278 3.2582728e-08 -0.099865503 -0.099865503 -0.099865503 - 24110 2.411 0.70687478 0.70687349 3.0570656e-08 -0.099865903 -0.099865903 -0.099865903 - 24120 2.412 0.70687549 0.70687419 2.756887e-08 -0.099866302 -0.099866302 -0.099866302 - 24130 2.413 0.7068762 0.70687489 2.3649372e-08 -0.0998667 -0.0998667 -0.0998667 - 24140 2.414 0.70687691 0.70687558 1.8905042e-08 -0.099867096 -0.099867096 -0.099867096 - 24150 2.415 0.70687761 0.70687628 1.3447443e-08 -0.099867492 -0.099867492 -0.099867492 - 24160 2.416 0.70687831 0.70687697 7.4041986e-09 -0.099867886 -0.099867886 -0.099867886 - 24170 2.417 0.706879 0.70687767 9.1600922e-10 -0.099868279 -0.099868279 -0.099868279 - 24180 2.418 0.7068797 0.70687836 -5.866621e-09 -0.099868671 -0.099868671 -0.099868671 - 24190 2.419 0.70688039 0.70687905 -1.2786874e-08 -0.099869061 -0.099869061 -0.099869061 - 24200 2.42 0.70688108 0.70687974 -1.9685241e-08 -0.09986945 -0.09986945 -0.09986945 - 24210 2.421 0.70688176 0.70688043 -2.6403201e-08 -0.099869839 -0.099869839 -0.099869839 - 24220 2.422 0.70688244 0.70688111 -3.2786856e-08 -0.099870226 -0.099870226 -0.099870226 - 24230 2.423 0.70688312 0.7068818 -3.8690462e-08 -0.099870611 -0.099870611 -0.099870611 - 24240 2.424 0.7068838 0.70688248 -4.3979751e-08 -0.099870996 -0.099870996 -0.099870996 - 24250 2.425 0.70688448 0.70688316 -4.8534982e-08 -0.09987138 -0.09987138 -0.09987138 - 24260 2.426 0.70688515 0.70688384 -5.2253654e-08 -0.099871762 -0.099871762 -0.099871762 - 24270 2.427 0.70688582 0.70688452 -5.5052807e-08 -0.099872143 -0.099872143 -0.099872143 - 24280 2.428 0.70688648 0.7068852 -5.6870872e-08 -0.099872523 -0.099872523 -0.099872523 - 24290 2.429 0.70688715 0.70688587 -5.7669019e-08 -0.099872902 -0.099872902 -0.099872902 - 24300 2.43 0.70688781 0.70688654 -5.7431987e-08 -0.09987328 -0.09987328 -0.09987328 - 24310 2.431 0.70688847 0.70688722 -5.6168356e-08 -0.099873656 -0.099873656 -0.099873656 - 24320 2.432 0.70688913 0.70688788 -5.3910283e-08 -0.099874032 -0.099874032 -0.099874032 - 24330 2.433 0.70688979 0.70688855 -5.071269e-08 -0.099874406 -0.099874406 -0.099874406 - 24340 2.434 0.70689045 0.70688921 -4.6651932e-08 -0.099874779 -0.099874779 -0.099874779 - 24350 2.435 0.7068911 0.70688987 -4.1823977e-08 -0.099875151 -0.099875151 -0.099875151 - 24360 2.436 0.70689175 0.70689053 -3.6342143e-08 -0.099875522 -0.099875522 -0.099875522 - 24370 2.437 0.70689241 0.70689119 -3.0334435e-08 -0.099875892 -0.099875892 -0.099875892 - 24380 2.438 0.70689306 0.70689184 -2.3940563e-08 -0.099876261 -0.099876261 -0.099876261 - 24390 2.439 0.70689371 0.70689249 -1.730869e-08 -0.099876628 -0.099876628 -0.099876628 - 24400 2.44 0.70689435 0.70689314 -1.0592007e-08 -0.099876995 -0.099876995 -0.099876995 - 24410 2.441 0.706895 0.70689379 -3.945187e-09 -0.09987736 -0.09987736 -0.09987736 - 24420 2.442 0.70689565 0.70689443 2.4791681e-09 -0.099877724 -0.099877724 -0.099877724 - 24430 2.443 0.70689629 0.70689507 8.5340334e-09 -0.099878087 -0.099878087 -0.099878087 - 24440 2.444 0.70689693 0.70689571 1.4081323e-08 -0.099878449 -0.099878449 -0.099878449 - 24450 2.445 0.70689757 0.70689634 1.8995038e-08 -0.09987881 -0.09987881 -0.09987881 - 24460 2.446 0.70689821 0.70689698 2.3164127e-08 -0.09987917 -0.09987917 -0.09987917 - 24470 2.447 0.70689885 0.70689761 2.6494993e-08 -0.099879529 -0.099879529 -0.099879529 - 24480 2.448 0.70689949 0.70689823 2.8913594e-08 -0.099879887 -0.099879887 -0.099879887 - 24490 2.449 0.70690012 0.70689886 3.0367085e-08 -0.099880243 -0.099880243 -0.099880243 - 24500 2.45 0.70690076 0.70689948 3.0824969e-08 -0.099880599 -0.099880599 -0.099880599 - 24510 2.451 0.70690139 0.70690011 3.0279732e-08 -0.099880953 -0.099880953 -0.099880953 - 24520 2.452 0.70690202 0.70690073 2.8746944e-08 -0.099881306 -0.099881306 -0.099881306 - 24530 2.453 0.70690265 0.70690134 2.6264834e-08 -0.099881659 -0.099881659 -0.099881659 - 24540 2.454 0.70690327 0.70690196 2.2893339e-08 -0.09988201 -0.09988201 -0.09988201 - 24550 2.455 0.70690389 0.70690258 1.8712663e-08 -0.09988236 -0.09988236 -0.09988236 - 24560 2.456 0.70690451 0.70690319 1.3821372e-08 -0.099882709 -0.099882709 -0.099882709 - 24570 2.457 0.70690513 0.7069038 8.3340722e-09 -0.099883057 -0.099883057 -0.099883057 - 24580 2.458 0.70690575 0.70690442 2.3787239e-09 -0.099883404 -0.099883404 -0.099883404 - 24590 2.459 0.70690636 0.70690503 -3.9063373e-09 -0.09988375 -0.09988375 -0.09988375 - 24600 2.46 0.70690697 0.70690564 -1.0375614e-08 -0.099884095 -0.099884095 -0.099884095 - 24610 2.461 0.70690758 0.70690624 -1.6879814e-08 -0.099884439 -0.099884439 -0.099884439 - 24620 2.462 0.70690818 0.70690685 -2.3269292e-08 -0.099884781 -0.099884781 -0.099884781 - 24630 2.463 0.70690879 0.70690746 -2.9397496e-08 -0.099885123 -0.099885123 -0.099885123 - 24640 2.464 0.70690939 0.70690806 -3.512432e-08 -0.099885464 -0.099885464 -0.099885464 - 24650 2.465 0.70690998 0.70690866 -4.0319315e-08 -0.099885803 -0.099885803 -0.099885803 - 24660 2.466 0.70691058 0.70690927 -4.486465e-08 -0.099886142 -0.099886142 -0.099886142 - 24670 2.467 0.70691117 0.70690987 -4.8657787e-08 -0.09988648 -0.09988648 -0.09988648 - 24680 2.468 0.70691176 0.70691047 -5.1613796e-08 -0.099886816 -0.099886816 -0.099886816 - 24690 2.469 0.70691235 0.70691106 -5.3667247e-08 -0.099887152 -0.099887152 -0.099887152 - 24700 2.47 0.70691294 0.70691166 -5.4773659e-08 -0.099887486 -0.099887486 -0.099887486 - 24710 2.471 0.70691353 0.70691225 -5.4910461e-08 -0.09988782 -0.09988782 -0.09988782 - 24720 2.472 0.70691411 0.70691285 -5.4077443e-08 -0.099888152 -0.099888152 -0.099888152 - 24730 2.473 0.70691469 0.70691344 -5.2296692e-08 -0.099888484 -0.099888484 -0.099888484 - 24740 2.474 0.70691527 0.70691403 -4.9612019e-08 -0.099888814 -0.099888814 -0.099888814 - 24750 2.475 0.70691585 0.70691461 -4.6087884e-08 -0.099889144 -0.099889144 -0.099889144 - 24760 2.476 0.70691643 0.7069152 -4.1807855e-08 -0.099889472 -0.099889472 -0.099889472 - 24770 2.477 0.706917 0.70691578 -3.6872624e-08 -0.0998898 -0.0998898 -0.0998898 - 24780 2.478 0.70691758 0.70691636 -3.1397643e-08 -0.099890126 -0.099890126 -0.099890126 - 24790 2.479 0.70691815 0.70691694 -2.5510426e-08 -0.099890452 -0.099890452 -0.099890452 - 24800 2.48 0.70691873 0.70691751 -1.9347578e-08 -0.099890777 -0.099890777 -0.099890777 - 24810 2.481 0.7069193 0.70691808 -1.3051629e-08 -0.0998911 -0.0998911 -0.0998911 - 24820 2.482 0.70691987 0.70691865 -6.767737e-09 -0.099891423 -0.099891423 -0.099891423 - 24830 2.483 0.70692044 0.70691922 -6.4034447e-10 -0.099891744 -0.099891744 -0.099891744 - 24840 2.484 0.70692101 0.70691979 5.1901416e-09 -0.099892065 -0.099892065 -0.099892065 - 24850 2.485 0.70692158 0.70692035 1.0590565e-08 -0.099892385 -0.099892385 -0.099892385 - 24860 2.486 0.70692214 0.70692091 1.5438062e-08 -0.099892703 -0.099892703 -0.099892703 - 24870 2.487 0.70692271 0.70692147 1.962285e-08 -0.099893021 -0.099893021 -0.099893021 - 24880 2.488 0.70692327 0.70692202 2.305072e-08 -0.099893338 -0.099893338 -0.099893338 - 24890 2.489 0.70692383 0.70692258 2.5645147e-08 -0.099893654 -0.099893654 -0.099893654 - 24900 2.49 0.70692439 0.70692313 2.7349003e-08 -0.099893968 -0.099893968 -0.099893968 - 24910 2.491 0.70692495 0.70692368 2.8125808e-08 -0.099894282 -0.099894282 -0.099894282 - 24920 2.492 0.70692551 0.70692423 2.7960507e-08 -0.099894595 -0.099894595 -0.099894595 - 24930 2.493 0.70692607 0.70692478 2.6859752e-08 -0.099894907 -0.099894907 -0.099894907 - 24940 2.494 0.70692662 0.70692532 2.4851683e-08 -0.099895218 -0.099895218 -0.099895218 - 24950 2.495 0.70692717 0.70692587 2.1985217e-08 -0.099895528 -0.099895528 -0.099895528 - 24960 2.496 0.70692772 0.70692641 1.8328859e-08 -0.099895838 -0.099895838 -0.099895838 - 24970 2.497 0.70692827 0.70692695 1.3969067e-08 -0.099896146 -0.099896146 -0.099896146 - 24980 2.498 0.70692882 0.70692749 9.0082126e-09 -0.099896453 -0.099896453 -0.099896453 - 24990 2.499 0.70692936 0.70692803 3.5621776e-09 -0.099896759 -0.099896759 -0.099896759 - 25000 2.5 0.7069299 0.70692857 -2.242352e-09 -0.099897065 -0.099897065 -0.099897065 - 25010 2.501 0.70693044 0.70692911 -8.2708303e-09 -0.099897369 -0.099897369 -0.099897369 - 25020 2.502 0.70693098 0.70692965 -1.438397e-08 -0.099897673 -0.099897673 -0.099897673 - 25030 2.503 0.70693151 0.70693018 -2.0440957e-08 -0.099897976 -0.099897976 -0.099897976 - 25040 2.504 0.70693205 0.70693072 -2.6302696e-08 -0.099898277 -0.099898277 -0.099898277 - 25050 2.505 0.70693258 0.70693125 -3.1835002e-08 -0.099898578 -0.099898578 -0.099898578 - 25060 2.506 0.7069331 0.70693178 -3.6911669e-08 -0.099898878 -0.099898878 -0.099898878 - 25070 2.507 0.70693363 0.70693232 -4.1417351e-08 -0.099899177 -0.099899177 -0.099899177 - 25080 2.508 0.70693415 0.70693285 -4.5250177e-08 -0.099899475 -0.099899475 -0.099899475 - 25090 2.509 0.70693468 0.70693338 -4.8324058e-08 -0.099899772 -0.099899772 -0.099899772 - 25100 2.51 0.7069352 0.7069339 -5.0570614e-08 -0.099900069 -0.099900069 -0.099900069 - 25110 2.511 0.70693571 0.70693443 -5.1940696e-08 -0.099900364 -0.099900364 -0.099900364 - 25120 2.512 0.70693623 0.70693495 -5.2405453e-08 -0.099900659 -0.099900659 -0.099900659 - 25130 2.513 0.70693675 0.70693548 -5.1956942e-08 -0.099900952 -0.099900952 -0.099900952 - 25140 2.514 0.70693726 0.706936 -5.0608239e-08 -0.099901245 -0.099901245 -0.099901245 - 25150 2.515 0.70693777 0.70693652 -4.8393082e-08 -0.099901537 -0.099901537 -0.099901537 - 25160 2.516 0.70693828 0.70693704 -4.5365025e-08 -0.099901828 -0.099901828 -0.099901828 - 25170 2.517 0.70693879 0.70693755 -4.1596156e-08 -0.099902118 -0.099902118 -0.099902118 - 25180 2.518 0.7069393 0.70693807 -3.7175374e-08 -0.099902407 -0.099902407 -0.099902407 - 25190 2.519 0.70693981 0.70693858 -3.2206301e-08 -0.099902695 -0.099902695 -0.099902695 - 25200 2.52 0.70694031 0.70693909 -2.6804852e-08 -0.099902983 -0.099902983 -0.099902983 - 25210 2.521 0.70694082 0.7069396 -2.1096532e-08 -0.099903269 -0.099903269 -0.099903269 - 25220 2.522 0.70694132 0.7069401 -1.5213525e-08 -0.099903555 -0.099903555 -0.099903555 - 25230 2.523 0.70694183 0.70694061 -9.2916271e-09 -0.09990384 -0.09990384 -0.09990384 - 25240 2.524 0.70694233 0.70694111 -3.4671218e-09 -0.099904124 -0.099904124 -0.099904124 - 25250 2.525 0.70694283 0.70694161 2.1263612e-09 -0.099904407 -0.099904407 -0.099904407 - 25260 2.526 0.70694333 0.70694211 7.3609082e-09 -0.099904689 -0.099904689 -0.099904689 - 25270 2.527 0.70694383 0.7069426 1.2117246e-08 -0.099904971 -0.099904971 -0.099904971 - 25280 2.528 0.70694433 0.70694309 1.6287457e-08 -0.099905251 -0.099905251 -0.099905251 - 25290 2.529 0.70694483 0.70694359 1.9777428e-08 -0.099905531 -0.099905531 -0.099905531 - 25300 2.53 0.70694533 0.70694407 2.2508973e-08 -0.09990581 -0.09990581 -0.09990581 - 25310 2.531 0.70694582 0.70694456 2.4421578e-08 -0.099906088 -0.099906088 -0.099906088 - 25320 2.532 0.70694632 0.70694505 2.5473747e-08 -0.099906365 -0.099906365 -0.099906365 - 25330 2.533 0.70694681 0.70694553 2.564389e-08 -0.099906641 -0.099906641 -0.099906641 - 25340 2.534 0.7069473 0.70694602 2.4930766e-08 -0.099906917 -0.099906917 -0.099906917 - 25350 2.535 0.70694779 0.7069465 2.3353447e-08 -0.099907191 -0.099907191 -0.099907191 - 25360 2.536 0.70694828 0.70694698 2.0950816e-08 -0.099907465 -0.099907465 -0.099907465 - 25370 2.537 0.70694876 0.70694746 1.7780618e-08 -0.099907738 -0.099907738 -0.099907738 - 25380 2.538 0.70694925 0.70694794 1.3918071e-08 -0.09990801 -0.09990801 -0.09990801 - 25390 2.539 0.70694973 0.70694841 9.4540864e-09 -0.099908281 -0.099908281 -0.099908281 - 25400 2.54 0.70695021 0.70694889 4.4931285e-09 -0.099908552 -0.099908552 -0.099908552 - 25410 2.541 0.70695069 0.70694936 -8.4922654e-10 -0.099908822 -0.099908822 -0.099908822 - 25420 2.542 0.70695117 0.70694984 -6.4489828e-09 -0.099909091 -0.099909091 -0.099909091 - 25430 2.543 0.70695164 0.70695031 -1.2176601e-08 -0.099909359 -0.099909359 -0.099909359 - 25440 2.544 0.70695211 0.70695078 -1.7899994e-08 -0.099909626 -0.099909626 -0.099909626 - 25450 2.545 0.70695258 0.70695126 -2.348757e-08 -0.099909892 -0.099909892 -0.099909892 - 25460 2.546 0.70695305 0.70695173 -2.8811262e-08 -0.099910158 -0.099910158 -0.099910158 - 25470 2.547 0.70695352 0.7069522 -3.3749454e-08 -0.099910423 -0.099910423 -0.099910423 - 25480 2.548 0.70695398 0.70695267 -3.8189766e-08 -0.099910687 -0.099910687 -0.099910687 - 25490 2.549 0.70695444 0.70695314 -4.2031604e-08 -0.09991095 -0.09991095 -0.09991095 - 25500 2.55 0.7069549 0.7069536 -4.5188441e-08 -0.099911212 -0.099911212 -0.099911212 - 25510 2.551 0.70695536 0.70695407 -4.7589763e-08 -0.099911474 -0.099911474 -0.099911474 - 25520 2.552 0.70695582 0.70695453 -4.9182641e-08 -0.099911735 -0.099911735 -0.099911735 - 25530 2.553 0.70695628 0.706955 -4.9932896e-08 -0.099911995 -0.099911995 -0.099911995 - 25540 2.554 0.70695673 0.70695546 -4.9825829e-08 -0.099912254 -0.099912254 -0.099912254 - 25550 2.555 0.70695718 0.70695592 -4.8866497e-08 -0.099912513 -0.099912513 -0.099912513 - 25560 2.556 0.70695764 0.70695638 -4.7079541e-08 -0.09991277 -0.09991277 -0.09991277 - 25570 2.557 0.70695809 0.70695684 -4.4508558e-08 -0.099913027 -0.099913027 -0.099913027 - 25580 2.558 0.70695854 0.7069573 -4.1215038e-08 -0.099913283 -0.099913283 -0.099913283 - 25590 2.559 0.70695899 0.70695775 -3.7276903e-08 -0.099913539 -0.099913539 -0.099913539 - 25600 2.56 0.70695943 0.7069582 -3.278666e-08 -0.099913793 -0.099913793 -0.099913793 - 25610 2.561 0.70695988 0.70695865 -2.7849232e-08 -0.099914047 -0.099914047 -0.099914047 - 25620 2.562 0.70696033 0.7069591 -2.2579507e-08 -0.0999143 -0.0999143 -0.0999143 - 25630 2.563 0.70696077 0.70695955 -1.7099665e-08 -0.099914552 -0.099914552 -0.099914552 - 25640 2.564 0.70696122 0.70695999 -1.1536349e-08 -0.099914804 -0.099914804 -0.099914804 - 25650 2.565 0.70696166 0.70696044 -6.0177391e-09 -0.099915055 -0.099915055 -0.099915055 - 25660 2.566 0.7069621 0.70696088 -6.7059702e-10 -0.099915305 -0.099915305 -0.099915305 - 25670 2.567 0.70696254 0.70696132 4.3826405e-09 -0.099915554 -0.099915554 -0.099915554 - 25680 2.568 0.70696299 0.70696175 9.026666e-09 -0.099915802 -0.099915802 -0.099915802 - 25690 2.569 0.70696343 0.70696219 1.3155931e-08 -0.09991605 -0.09991605 -0.09991605 - 25700 2.57 0.70696387 0.70696262 1.6677042e-08 -0.099916297 -0.099916297 -0.099916297 - 25710 2.571 0.70696431 0.70696305 1.9510875e-08 -0.099916543 -0.099916543 -0.099916543 - 25720 2.572 0.70696474 0.70696348 2.1594347e-08 -0.099916789 -0.099916789 -0.099916789 - 25730 2.573 0.70696518 0.70696391 2.2881822e-08 -0.099917033 -0.099917033 -0.099917033 - 25740 2.574 0.70696561 0.70696434 2.3346104e-08 -0.099917277 -0.099917277 -0.099917277 - 25750 2.575 0.70696605 0.70696477 2.297901e-08 -0.09991752 -0.09991752 -0.09991752 - 25760 2.576 0.70696648 0.70696519 2.1791499e-08 -0.099917763 -0.099917763 -0.099917763 - 25770 2.577 0.70696691 0.70696562 1.9813363e-08 -0.099918005 -0.099918005 -0.099918005 - 25780 2.578 0.70696734 0.70696604 1.7092482e-08 -0.099918246 -0.099918246 -0.099918246 - 25790 2.579 0.70696777 0.70696646 1.3693673e-08 -0.099918486 -0.099918486 -0.099918486 - 25800 2.58 0.7069682 0.70696688 9.6971429e-09 -0.099918726 -0.099918726 -0.099918726 - 25810 2.581 0.70696862 0.7069673 5.1966028e-09 -0.099918964 -0.099918964 -0.099918964 - 25820 2.582 0.70696904 0.70696772 2.9706868e-10 -0.099919203 -0.099919203 -0.099919203 - 25830 2.583 0.70696946 0.70696814 -4.8875861e-09 -0.09991944 -0.09991944 -0.09991944 - 25840 2.584 0.70696988 0.70696856 -1.0237277e-08 -0.099919677 -0.099919677 -0.099919677 - 25850 2.585 0.7069703 0.70696898 -1.5628487e-08 -0.099919913 -0.099919913 -0.099919913 - 25860 2.586 0.70697072 0.70696939 -2.093712e-08 -0.099920148 -0.099920148 -0.099920148 - 25870 2.587 0.70697113 0.70696981 -2.6041352e-08 -0.099920382 -0.099920382 -0.099920382 - 25880 2.588 0.70697154 0.70697022 -3.0824431e-08 -0.099920616 -0.099920616 -0.099920616 - 25890 2.589 0.70697195 0.70697064 -3.5177341e-08 -0.099920849 -0.099920849 -0.099920849 - 25900 2.59 0.70697236 0.70697105 -3.9001289e-08 -0.099921082 -0.099921082 -0.099921082 - 25910 2.591 0.70697277 0.70697146 -4.2209945e-08 -0.099921313 -0.099921313 -0.099921313 - 25920 2.592 0.70697317 0.70697188 -4.4731387e-08 -0.099921544 -0.099921544 -0.099921544 - 25930 2.593 0.70697357 0.70697229 -4.6509718e-08 -0.099921775 -0.099921775 -0.099921775 - 25940 2.594 0.70697398 0.7069727 -4.7506293e-08 -0.099922004 -0.099922004 -0.099922004 - 25950 2.595 0.70697438 0.7069731 -4.7700565e-08 -0.099922233 -0.099922233 -0.099922233 - 25960 2.596 0.70697478 0.70697351 -4.7090496e-08 -0.099922462 -0.099922462 -0.099922462 - 25970 2.597 0.70697518 0.70697392 -4.569255e-08 -0.099922689 -0.099922689 -0.099922689 - 25980 2.598 0.70697557 0.70697432 -4.3541262e-08 -0.099922916 -0.099922916 -0.099922916 - 25990 2.599 0.70697597 0.70697472 -4.0688383e-08 -0.099923142 -0.099923142 -0.099923142 - 26000 2.6 0.70697637 0.70697513 -3.7201641e-08 -0.099923367 -0.099923367 -0.099923367 - 26010 2.601 0.70697676 0.70697553 -3.3163136e-08 -0.099923592 -0.099923592 -0.099923592 - 26020 2.602 0.70697716 0.70697592 -2.8667406e-08 -0.099923816 -0.099923816 -0.099923816 - 26030 2.603 0.70697755 0.70697632 -2.3819219e-08 -0.09992404 -0.09992404 -0.09992404 - 26040 2.604 0.70697794 0.70697672 -1.873113e-08 -0.099924262 -0.099924262 -0.099924262 - 26050 2.605 0.70697833 0.70697711 -1.3520869e-08 -0.099924485 -0.099924485 -0.099924485 - 26060 2.606 0.70697873 0.7069775 -8.3086186e-09 -0.099924706 -0.099924706 -0.099924706 - 26070 2.607 0.70697912 0.70697789 -3.2142456e-09 -0.099924927 -0.099924927 -0.099924927 - 26080 2.608 0.70697951 0.70697828 1.6454587e-09 -0.099925147 -0.099925147 -0.099925147 - 26090 2.609 0.7069799 0.70697866 6.1594525e-09 -0.099925366 -0.099925366 -0.099925366 - 26100 2.61 0.70698029 0.70697905 1.022498e-08 -0.099925585 -0.099925585 -0.099925585 - 26110 2.611 0.70698067 0.70697943 1.374991e-08 -0.099925803 -0.099925803 -0.099925803 - 26120 2.612 0.70698106 0.70697981 1.665482e-08 -0.09992602 -0.09992602 -0.09992602 - 26130 2.613 0.70698145 0.70698019 1.8874789e-08 -0.099926237 -0.099926237 -0.099926237 - 26140 2.614 0.70698183 0.70698057 2.0360839e-08 -0.099926453 -0.099926453 -0.099926453 - 26150 2.615 0.70698222 0.70698095 2.1081022e-08 -0.099926668 -0.099926668 -0.099926668 - 26160 2.616 0.7069826 0.70698132 2.1021096e-08 -0.099926883 -0.099926883 -0.099926883 - 26170 2.617 0.70698298 0.7069817 2.0184801e-08 -0.099927097 -0.099927097 -0.099927097 - 26180 2.618 0.70698336 0.70698207 1.8593721e-08 -0.099927311 -0.099927311 -0.099927311 - 26190 2.619 0.70698374 0.70698245 1.6286729e-08 -0.099927524 -0.099927524 -0.099927524 - 26200 2.62 0.70698412 0.70698282 1.3319047e-08 -0.099927736 -0.099927736 -0.099927736 - 26210 2.621 0.7069845 0.70698319 9.7609198e-09 -0.099927947 -0.099927947 -0.099927947 - 26220 2.622 0.70698487 0.70698356 5.695959e-09 -0.099928158 -0.099928158 -0.099928158 - 26230 2.623 0.70698525 0.70698393 1.2191777e-09 -0.099928368 -0.099928368 -0.099928368 - 26240 2.624 0.70698562 0.7069843 -3.5652283e-09 -0.099928578 -0.099928578 -0.099928578 - 26250 2.625 0.70698599 0.70698467 -8.5463044e-09 -0.099928787 -0.099928787 -0.099928787 - 26260 2.626 0.70698636 0.70698504 -1.360891e-08 -0.099928995 -0.099928995 -0.099928995 - 26270 2.627 0.70698672 0.7069854 -1.8636377e-08 -0.099929203 -0.099929203 -0.099929203 - 26280 2.628 0.70698709 0.70698577 -2.3513199e-08 -0.09992941 -0.09992941 -0.09992941 - 26290 2.629 0.70698745 0.70698614 -2.8127686e-08 -0.099929617 -0.099929617 -0.099929617 - 26300 2.63 0.70698782 0.7069865 -3.2374515e-08 -0.099929823 -0.099929823 -0.099929823 - 26310 2.631 0.70698818 0.70698687 -3.615714e-08 -0.099930028 -0.099930028 -0.099930028 - 26320 2.632 0.70698854 0.70698723 -3.938998e-08 -0.099930232 -0.099930232 -0.099930232 - 26330 2.633 0.70698889 0.7069876 -4.2000359e-08 -0.099930436 -0.099930436 -0.099930436 - 26340 2.634 0.70698925 0.70698796 -4.3930131e-08 -0.09993064 -0.09993064 -0.09993064 - 26350 2.635 0.7069896 0.70698832 -4.5136983e-08 -0.099930842 -0.099930842 -0.099930842 - 26360 2.636 0.70698996 0.70698868 -4.5595349e-08 -0.099931044 -0.099931044 -0.099931044 - 26370 2.637 0.70699031 0.70698904 -4.5296959e-08 -0.099931246 -0.099931246 -0.099931246 - 26380 2.638 0.70699066 0.7069894 -4.4250965e-08 -0.099931447 -0.099931447 -0.099931447 - 26390 2.639 0.70699101 0.70698976 -4.2483687e-08 -0.099931647 -0.099931647 -0.099931647 - 26400 2.64 0.70699136 0.70699011 -4.0037951e-08 -0.099931847 -0.099931847 -0.099931847 - 26410 2.641 0.70699171 0.70699047 -3.6972056e-08 -0.099932046 -0.099932046 -0.099932046 - 26420 2.642 0.70699206 0.70699082 -3.3358386e-08 -0.099932244 -0.099932244 -0.099932244 - 26430 2.643 0.70699241 0.70699117 -2.9281703e-08 -0.099932442 -0.099932442 -0.099932442 - 26440 2.644 0.70699276 0.70699152 -2.4837158e-08 -0.099932639 -0.099932639 -0.099932639 - 26450 2.645 0.7069931 0.70699187 -2.0128076e-08 -0.099932836 -0.099932836 -0.099932836 - 26460 2.646 0.70699345 0.70699222 -1.5263551e-08 -0.099933032 -0.099933032 -0.099933032 - 26470 2.647 0.70699379 0.70699257 -1.0355922e-08 -0.099933228 -0.099933228 -0.099933228 - 26480 2.648 0.70699414 0.70699291 -5.5181785e-09 -0.099933423 -0.099933423 -0.099933423 - 26490 2.649 0.70699448 0.70699325 -8.6136106e-10 -0.099933617 -0.099933617 -0.099933617 - 26500 2.65 0.70699483 0.70699359 3.507987e-09 -0.099933811 -0.099933811 -0.099933811 - 26510 2.651 0.70699517 0.70699393 7.4902557e-09 -0.099934004 -0.099934004 -0.099934004 - 26520 2.652 0.70699551 0.70699427 1.0995039e-08 -0.099934196 -0.099934196 -0.099934196 - 26530 2.653 0.70699586 0.70699461 1.3943183e-08 -0.099934388 -0.099934388 -0.099934388 - 26540 2.654 0.7069962 0.70699494 1.6268578e-08 -0.099934579 -0.099934579 -0.099934579 - 26550 2.655 0.70699654 0.70699528 1.7919633e-08 -0.09993477 -0.09993477 -0.09993477 - 26560 2.656 0.70699688 0.70699561 1.8860422e-08 -0.09993496 -0.09993496 -0.09993496 - 26570 2.657 0.70699722 0.70699594 1.9071461e-08 -0.09993515 -0.09993515 -0.09993515 - 26580 2.658 0.70699755 0.70699627 1.8550109e-08 -0.099935339 -0.099935339 -0.099935339 - 26590 2.659 0.70699789 0.7069966 1.7310572e-08 -0.099935528 -0.099935528 -0.099935528 - 26600 2.66 0.70699823 0.70699693 1.5383533e-08 -0.099935716 -0.099935716 -0.099935716 - 26610 2.661 0.70699856 0.70699726 1.281539e-08 -0.099935903 -0.099935903 -0.099935903 - 26620 2.662 0.70699889 0.70699759 9.6671452e-09 -0.09993609 -0.09993609 -0.09993609 - 26630 2.663 0.70699922 0.70699791 6.0129553e-09 -0.099936276 -0.099936276 -0.099936276 - 26640 2.664 0.70699955 0.70699824 1.9383889e-09 -0.099936461 -0.099936461 -0.099936461 - 26650 2.665 0.70699988 0.70699857 -2.4615778e-09 -0.099936647 -0.099936647 -0.099936647 - 26660 2.666 0.70700021 0.70699889 -7.0847727e-09 -0.099936831 -0.099936831 -0.099936831 - 26670 2.667 0.70700054 0.70699922 -1.18242e-08 -0.099937015 -0.099937015 -0.099937015 - 26680 2.668 0.70700086 0.70699954 -1.6570514e-08 -0.099937198 -0.099937198 -0.099937198 - 26690 2.669 0.70700118 0.70699987 -2.1214544e-08 -0.099937381 -0.099937381 -0.099937381 - 26700 2.67 0.7070015 0.70700019 -2.5649799e-08 -0.099937564 -0.099937564 -0.099937564 - 26710 2.671 0.70700182 0.70700051 -2.9774915e-08 -0.099937745 -0.099937745 -0.099937745 - 26720 2.672 0.70700214 0.70700083 -3.3495964e-08 -0.099937926 -0.099937926 -0.099937926 - 26730 2.673 0.70700246 0.70700116 -3.6728598e-08 -0.099938107 -0.099938107 -0.099938107 - 26740 2.674 0.70700277 0.70700148 -3.9399956e-08 -0.099938287 -0.099938287 -0.099938287 - 26750 2.675 0.70700309 0.7070018 -4.1450304e-08 -0.099938467 -0.099938467 -0.099938467 - 26760 2.676 0.7070034 0.70700212 -4.2834371e-08 -0.099938646 -0.099938646 -0.099938646 - 26770 2.677 0.70700371 0.70700244 -4.3522347e-08 -0.099938824 -0.099938824 -0.099938824 - 26780 2.678 0.70700403 0.70700275 -4.3500519e-08 -0.099939002 -0.099939002 -0.099939002 - 26790 2.679 0.70700434 0.70700307 -4.2771539e-08 -0.099939179 -0.099939179 -0.099939179 - 26800 2.68 0.70700465 0.70700339 -4.1354316e-08 -0.099939356 -0.099939356 -0.099939356 - 26810 2.681 0.70700495 0.7070037 -3.9283528e-08 -0.099939533 -0.099939533 -0.099939533 - 26820 2.682 0.70700526 0.70700401 -3.6608776e-08 -0.099939708 -0.099939708 -0.099939708 - 26830 2.683 0.70700557 0.70700433 -3.3393404e-08 -0.099939884 -0.099939884 -0.099939884 - 26840 2.684 0.70700588 0.70700464 -2.9712994e-08 -0.099940058 -0.099940058 -0.099940058 - 26850 2.685 0.70700618 0.70700495 -2.5653597e-08 -0.099940232 -0.099940232 -0.099940232 - 26860 2.686 0.70700649 0.70700526 -2.1309716e-08 -0.099940406 -0.099940406 -0.099940406 - 26870 2.687 0.70700679 0.70700556 -1.6782111e-08 -0.099940579 -0.099940579 -0.099940579 - 26880 2.688 0.7070071 0.70700587 -1.2175464e-08 -0.099940752 -0.099940752 -0.099940752 - 26890 2.689 0.7070074 0.70700617 -7.5959545e-09 -0.099940924 -0.099940924 -0.099940924 - 26900 2.69 0.70700771 0.70700647 -3.1488182e-09 -0.099941095 -0.099941095 -0.099941095 - 26910 2.691 0.70700801 0.70700677 1.0640726e-09 -0.099941266 -0.099941266 -0.099941266 - 26920 2.692 0.70700831 0.70700707 4.9465414e-09 -0.099941437 -0.099941437 -0.099941437 - 26930 2.693 0.70700862 0.70700737 8.4103017e-09 -0.099941607 -0.099941607 -0.099941607 - 26940 2.694 0.70700892 0.70700767 1.1376964e-08 -0.099941776 -0.099941776 -0.099941776 - 26950 2.695 0.70700922 0.70700797 1.3779808e-08 -0.099941945 -0.099941945 -0.099941945 - 26960 2.696 0.70700952 0.70700826 1.5565283e-08 -0.099942114 -0.099942114 -0.099942114 - 26970 2.697 0.70700982 0.70700855 1.6694197e-08 -0.099942282 -0.099942282 -0.099942282 - 26980 2.698 0.70701012 0.70700885 1.7142578e-08 -0.099942449 -0.099942449 -0.099942449 - 26990 2.699 0.70701042 0.70700914 1.6902175e-08 -0.099942616 -0.099942616 -0.099942616 - 27000 2.7 0.70701072 0.70700943 1.5980604e-08 -0.099942783 -0.099942783 -0.099942783 - 27010 2.701 0.70701101 0.70700972 1.4401123e-08 -0.099942948 -0.099942948 -0.099942948 - 27020 2.702 0.70701131 0.70701001 1.220205e-08 -0.099943114 -0.099943114 -0.099943114 - 27030 2.703 0.7070116 0.7070103 9.435837e-09 -0.099943279 -0.099943279 -0.099943279 - 27040 2.704 0.7070119 0.70701059 6.1678181e-09 -0.099943443 -0.099943443 -0.099943443 - 27050 2.705 0.70701219 0.70701088 2.4746714e-09 -0.099943607 -0.099943607 -0.099943607 - 27060 2.706 0.70701248 0.70701116 -1.5573806e-09 -0.09994377 -0.09994377 -0.09994377 - 27070 2.707 0.70701277 0.70701145 -5.8345826e-09 -0.099943933 -0.099943933 -0.099943933 - 27080 2.708 0.70701305 0.70701174 -1.0257825e-08 -0.099944096 -0.099944096 -0.099944096 - 27090 2.709 0.70701334 0.70701202 -1.4724941e-08 -0.099944258 -0.099944258 -0.099944258 - 27100 2.71 0.70701363 0.70701231 -1.9133063e-08 -0.099944419 -0.099944419 -0.099944419 - 27110 2.711 0.70701391 0.7070126 -2.3380992e-08 -0.09994458 -0.09994458 -0.09994458 - 27120 2.712 0.70701419 0.70701288 -2.737152e-08 -0.099944741 -0.099944741 -0.099944741 - 27130 2.713 0.70701447 0.70701317 -3.1013653e-08 -0.099944901 -0.099944901 -0.099944901 - 27140 2.714 0.70701475 0.70701345 -3.4224685e-08 -0.09994506 -0.09994506 -0.09994506 - 27150 2.715 0.70701503 0.70701373 -3.6932076e-08 -0.099945219 -0.099945219 -0.099945219 - 27160 2.716 0.70701531 0.70701402 -3.9075088e-08 -0.099945378 -0.099945378 -0.099945378 - 27170 2.717 0.70701558 0.7070143 -4.0606144e-08 -0.099945536 -0.099945536 -0.099945536 - 27180 2.718 0.70701586 0.70701458 -4.149189e-08 -0.099945693 -0.099945693 -0.099945693 - 27190 2.719 0.70701613 0.70701486 -4.171391e-08 -0.09994585 -0.09994585 -0.09994585 - 27200 2.72 0.70701641 0.70701514 -4.1269108e-08 -0.099946007 -0.099946007 -0.099946007 - 27210 2.721 0.70701668 0.70701542 -4.0169737e-08 -0.099946163 -0.099946163 -0.099946163 - 27220 2.722 0.70701695 0.7070157 -3.8443063e-08 -0.099946319 -0.099946319 -0.099946319 - 27230 2.723 0.70701723 0.70701597 -3.6130697e-08 -0.099946474 -0.099946474 -0.099946474 - 27240 2.724 0.7070175 0.70701625 -3.3287594e-08 -0.099946629 -0.099946629 -0.099946629 - 27250 2.725 0.70701777 0.70701653 -2.998075e-08 -0.099946783 -0.099946783 -0.099946783 - 27260 2.726 0.70701804 0.7070168 -2.628762e-08 -0.099946937 -0.099946937 -0.099946937 - 27270 2.727 0.70701831 0.70701707 -2.2294312e-08 -0.09994709 -0.09994709 -0.09994709 - 27280 2.728 0.70701858 0.70701734 -1.8093574e-08 -0.099947243 -0.099947243 -0.099947243 - 27290 2.729 0.70701885 0.70701761 -1.3782643e-08 -0.099947395 -0.099947395 -0.099947395 - 27300 2.73 0.70701912 0.70701788 -9.4609994e-09 -0.099947547 -0.099947547 -0.099947547 - 27310 2.731 0.70701938 0.70701815 -5.2280646e-09 -0.099947699 -0.099947699 -0.099947699 - 27320 2.732 0.70701965 0.70701841 -1.1809204e-09 -0.09994785 -0.09994785 -0.09994785 - 27330 2.733 0.70701992 0.70701868 2.5879185e-09 -0.099948 -0.099948 -0.099948 - 27340 2.734 0.70702019 0.70701894 5.9926183e-09 -0.09994815 -0.09994815 -0.09994815 - 27350 2.735 0.70702045 0.7070192 8.9559802e-09 -0.0999483 -0.0999483 -0.0999483 - 27360 2.736 0.70702072 0.70701947 1.1411189e-08 -0.099948449 -0.099948449 -0.099948449 - 27370 2.737 0.70702099 0.70701973 1.3303318e-08 -0.099948598 -0.099948598 -0.099948598 - 27380 2.738 0.70702125 0.70701998 1.4590559e-08 -0.099948746 -0.099948746 -0.099948746 - 27390 2.739 0.70702151 0.70702024 1.524514e-08 -0.099948894 -0.099948894 -0.099948894 - 27400 2.74 0.70702178 0.7070205 1.5253923e-08 -0.099949041 -0.099949041 -0.099949041 - 27410 2.741 0.70702204 0.70702076 1.4618664e-08 -0.099949188 -0.099949188 -0.099949188 - 27420 2.742 0.7070223 0.70702101 1.3355924e-08 -0.099949335 -0.099949335 -0.099949335 - 27430 2.743 0.70702256 0.70702127 1.1496647e-08 -0.099949481 -0.099949481 -0.099949481 - 27440 2.744 0.70702282 0.70702152 9.0853996e-09 -0.099949626 -0.099949626 -0.099949626 - 27450 2.745 0.70702308 0.70702178 6.1793106e-09 -0.099949771 -0.099949771 -0.099949771 - 27460 2.746 0.70702334 0.70702203 2.8467151e-09 -0.099949916 -0.099949916 -0.099949916 - 27470 2.747 0.7070236 0.70702229 -8.3444954e-10 -0.09995006 -0.09995006 -0.09995006 - 27480 2.748 0.70702385 0.70702254 -4.7784655e-09 -0.099950204 -0.099950204 -0.099950204 - 27490 2.749 0.70702411 0.70702279 -8.8938295e-09 -0.099950348 -0.099950348 -0.099950348 - 27500 2.75 0.70702436 0.70702305 -1.3085375e-08 -0.099950491 -0.099950491 -0.099950491 - 27510 2.751 0.70702461 0.7070233 -1.7256471e-08 -0.099950633 -0.099950633 -0.099950633 - 27520 2.752 0.70702486 0.70702355 -2.131125e-08 -0.099950775 -0.099950775 -0.099950775 - 27530 2.753 0.70702511 0.7070238 -2.5156811e-08 -0.099950917 -0.099950917 -0.099950917 - 27540 2.754 0.70702536 0.70702405 -2.8705344e-08 -0.099951058 -0.099951058 -0.099951058 - 27550 2.755 0.70702561 0.7070243 -3.187614e-08 -0.099951199 -0.099951199 -0.099951199 - 27560 2.756 0.70702585 0.70702455 -3.4597417e-08 -0.099951339 -0.099951339 -0.099951339 - 27570 2.757 0.7070261 0.7070248 -3.6807954e-08 -0.099951479 -0.099951479 -0.099951479 - 27580 2.758 0.70702634 0.70702505 -3.8458458e-08 -0.099951619 -0.099951619 -0.099951619 - 27590 2.759 0.70702658 0.7070253 -3.9512667e-08 -0.099951758 -0.099951758 -0.099951758 - 27600 2.76 0.70702683 0.70702555 -3.9948144e-08 -0.099951897 -0.099951897 -0.099951897 - 27610 2.761 0.70702707 0.7070258 -3.9756748e-08 -0.099952035 -0.099952035 -0.099952035 - 27620 2.762 0.70702731 0.70702604 -3.8944781e-08 -0.099952173 -0.099952173 -0.099952173 - 27630 2.763 0.70702755 0.70702629 -3.7532797e-08 -0.09995231 -0.09995231 -0.09995231 - 27640 2.764 0.70702779 0.70702653 -3.5555091e-08 -0.099952447 -0.099952447 -0.099952447 - 27650 2.765 0.70702803 0.70702678 -3.3058861e-08 -0.099952584 -0.099952584 -0.099952584 - 27660 2.766 0.70702827 0.70702702 -3.010309e-08 -0.09995272 -0.09995272 -0.09995272 - 27670 2.767 0.7070285 0.70702726 -2.6757149e-08 -0.099952856 -0.099952856 -0.099952856 - 27680 2.768 0.70702874 0.7070275 -2.3099175e-08 -0.099952991 -0.099952991 -0.099952991 - 27690 2.769 0.70702898 0.70702774 -1.9214242e-08 -0.099953126 -0.099953126 -0.099953126 - 27700 2.77 0.70702922 0.70702798 -1.5192388e-08 -0.099953261 -0.099953261 -0.099953261 - 27710 2.771 0.70702946 0.70702822 -1.1126526e-08 -0.099953395 -0.099953395 -0.099953395 - 27720 2.772 0.70702969 0.70702845 -7.1102999e-09 -0.099953529 -0.099953529 -0.099953529 - 27730 2.773 0.70702993 0.70702869 -3.235929e-09 -0.099953662 -0.099953662 -0.099953662 - 27740 2.774 0.70703016 0.70702892 4.0791023e-10 -0.099953795 -0.099953795 -0.099953795 - 27750 2.775 0.7070304 0.70702916 3.7381119e-09 -0.099953927 -0.099953927 -0.099953927 - 27760 2.776 0.70703064 0.70702939 6.6790351e-09 -0.099954059 -0.099954059 -0.099954059 - 27770 2.777 0.70703087 0.70702962 9.1642213e-09 -0.099954191 -0.099954191 -0.099954191 - 27780 2.778 0.70703111 0.70702985 1.1137895e-08 -0.099954322 -0.099954322 -0.099954322 - 27790 2.779 0.70703134 0.70703008 1.2556213e-08 -0.099954453 -0.099954453 -0.099954453 - 27800 2.78 0.70703157 0.7070303 1.338824e-08 -0.099954584 -0.099954584 -0.099954584 - 27810 2.781 0.70703181 0.70703053 1.3616615e-08 -0.099954714 -0.099954714 -0.099954714 - 27820 2.782 0.70703204 0.70703076 1.3237917e-08 -0.099954844 -0.099954844 -0.099954844 - 27830 2.783 0.70703227 0.70703098 1.2262695e-08 -0.099954973 -0.099954973 -0.099954973 - 27840 2.784 0.7070325 0.70703121 1.0715186e-08 -0.099955102 -0.099955102 -0.099955102 - 27850 2.785 0.70703273 0.70703143 8.6327161e-09 -0.099955231 -0.099955231 -0.099955231 - 27860 2.786 0.70703296 0.70703166 6.0648015e-09 -0.099955359 -0.099955359 -0.099955359 - 27870 2.787 0.70703319 0.70703188 3.0719735e-09 -0.099955487 -0.099955487 -0.099955487 - 27880 2.788 0.70703341 0.70703211 -2.7564735e-10 -0.099955614 -0.099955614 -0.099955614 - 27890 2.789 0.70703364 0.70703233 -3.8999933e-09 -0.099955741 -0.099955741 -0.099955741 - 27900 2.79 0.70703386 0.70703255 -7.7168685e-09 -0.099955868 -0.099955868 -0.099955868 - 27910 2.791 0.70703409 0.70703278 -1.1637904e-08 -0.099955994 -0.099955994 -0.099955994 - 27920 2.792 0.70703431 0.707033 -1.5572604e-08 -0.09995612 -0.09995612 -0.09995612 - 27930 2.793 0.70703453 0.70703322 -1.9430432e-08 -0.099956245 -0.099956245 -0.099956245 - 27940 2.794 0.70703475 0.70703344 -2.3122893e-08 -0.09995637 -0.09995637 -0.09995637 - 27950 2.795 0.70703497 0.70703366 -2.6565565e-08 -0.099956495 -0.099956495 -0.099956495 - 27960 2.796 0.70703519 0.70703389 -2.9680026e-08 -0.099956619 -0.099956619 -0.099956619 - 27970 2.797 0.70703541 0.70703411 -3.2395641e-08 -0.099956743 -0.099956743 -0.099956743 - 27980 2.798 0.70703562 0.70703433 -3.465116e-08 -0.099956867 -0.099956867 -0.099956867 - 27990 2.799 0.70703584 0.70703455 -3.6396105e-08 -0.09995699 -0.09995699 -0.09995699 - 28000 2.8 0.70703605 0.70703477 -3.7591888e-08 -0.099957113 -0.099957113 -0.099957113 - 28010 2.801 0.70703627 0.70703499 -3.8212674e-08 -0.099957235 -0.099957235 -0.099957235 - 28020 2.802 0.70703648 0.70703521 -3.8245927e-08 -0.099957357 -0.099957357 -0.099957357 - 28030 2.803 0.70703669 0.70703542 -3.7692663e-08 -0.099957479 -0.099957479 -0.099957479 - 28040 2.804 0.7070369 0.70703564 -3.6567386e-08 -0.0999576 -0.0999576 -0.0999576 - 28050 2.805 0.70703711 0.70703586 -3.4897709e-08 -0.099957721 -0.099957721 -0.099957721 - 28060 2.806 0.70703733 0.70703607 -3.2723685e-08 -0.099957842 -0.099957842 -0.099957842 - 28070 2.807 0.70703754 0.70703629 -3.0096843e-08 -0.099957962 -0.099957962 -0.099957962 - 28080 2.808 0.70703775 0.7070365 -2.7078973e-08 -0.099958082 -0.099958082 -0.099958082 - 28090 2.809 0.70703796 0.70703671 -2.374067e-08 -0.099958202 -0.099958202 -0.099958202 - 28100 2.81 0.70703817 0.70703693 -2.0159683e-08 -0.099958321 -0.099958321 -0.099958321 - 28110 2.811 0.70703838 0.70703714 -1.641911e-08 -0.09995844 -0.09995844 -0.09995844 - 28120 2.812 0.70703858 0.70703735 -1.2605466e-08 -0.099958558 -0.099958558 -0.099958558 - 28130 2.813 0.70703879 0.70703755 -8.8066839e-09 -0.099958676 -0.099958676 -0.099958676 - 28140 2.814 0.707039 0.70703776 -5.1100898e-09 -0.099958794 -0.099958794 -0.099958794 - 28150 2.815 0.70703921 0.70703797 -1.6003939e-09 -0.099958911 -0.099958911 -0.099958911 - 28160 2.816 0.70703942 0.70703817 1.6422488e-09 -0.099959028 -0.099959028 -0.099959028 - 28170 2.817 0.70703963 0.70703838 4.5440682e-09 -0.099959145 -0.099959145 -0.099959145 - 28180 2.818 0.70703983 0.70703858 7.0393568e-09 -0.099959261 -0.099959261 -0.099959261 - 28190 2.819 0.70704004 0.70703878 9.071956e-09 -0.099959377 -0.099959377 -0.099959377 - 28200 2.82 0.70704025 0.70703899 1.0596519e-08 -0.099959493 -0.099959493 -0.099959493 - 28210 2.821 0.70704046 0.70703919 1.1579522e-08 -0.099959608 -0.099959608 -0.099959608 - 28220 2.822 0.70704066 0.70703939 1.1999998e-08 -0.099959723 -0.099959723 -0.099959723 - 28230 2.823 0.70704087 0.70703959 1.184998e-08 -0.099959837 -0.099959837 -0.099959837 - 28240 2.824 0.70704107 0.70703979 1.1134648e-08 -0.099959951 -0.099959951 -0.099959951 - 28250 2.825 0.70704127 0.70703999 9.8721685e-09 -0.099960065 -0.099960065 -0.099960065 - 28260 2.826 0.70704148 0.70704018 8.0932366e-09 -0.099960179 -0.099960179 -0.099960179 - 28270 2.827 0.70704168 0.70704038 5.8403326e-09 -0.099960292 -0.099960292 -0.099960292 - 28280 2.828 0.70704188 0.70704058 3.1667092e-09 -0.099960405 -0.099960405 -0.099960405 - 28290 2.829 0.70704208 0.70704078 1.3513454e-10 -0.099960517 -0.099960517 -0.099960517 - 28300 2.83 0.70704228 0.70704097 -3.183581e-09 -0.099960629 -0.099960629 -0.099960629 - 28310 2.831 0.70704248 0.70704117 -6.7122374e-09 -0.099960741 -0.099960741 -0.099960741 - 28320 2.832 0.70704268 0.70704137 -1.036904e-08 -0.099960853 -0.099960853 -0.099960853 - 28330 2.833 0.70704287 0.70704156 -1.4069495e-08 -0.099960964 -0.099960964 -0.099960964 - 28340 2.834 0.70704307 0.70704176 -1.7728359e-08 -0.099961074 -0.099961074 -0.099961074 - 28350 2.835 0.70704326 0.70704196 -2.1261607e-08 -0.099961185 -0.099961185 -0.099961185 - 28360 2.836 0.70704346 0.70704215 -2.4588354e-08 -0.099961295 -0.099961295 -0.099961295 - 28370 2.837 0.70704365 0.70704235 -2.7632713e-08 -0.099961405 -0.099961405 -0.099961405 - 28380 2.838 0.70704384 0.70704254 -3.0325519e-08 -0.099961514 -0.099961514 -0.099961514 - 28390 2.839 0.70704403 0.70704274 -3.2605904e-08 -0.099961623 -0.099961623 -0.099961623 - 28400 2.84 0.70704422 0.70704293 -3.442267e-08 -0.099961732 -0.099961732 -0.099961732 - 28410 2.841 0.70704441 0.70704313 -3.5735436e-08 -0.099961841 -0.099961841 -0.099961841 - 28420 2.842 0.7070446 0.70704332 -3.6515538e-08 -0.099961949 -0.099961949 -0.099961949 - 28430 2.843 0.70704479 0.70704351 -3.6746647e-08 -0.099962056 -0.099962056 -0.099962056 - 28440 2.844 0.70704498 0.70704371 -3.6425114e-08 -0.099962164 -0.099962164 -0.099962164 - 28450 2.845 0.70704516 0.7070439 -3.5560007e-08 -0.099962271 -0.099962271 -0.099962271 - 28460 2.846 0.70704535 0.70704409 -3.4172873e-08 -0.099962378 -0.099962378 -0.099962378 - 28470 2.847 0.70704553 0.70704428 -3.2297198e-08 -0.099962484 -0.099962484 -0.099962484 - 28480 2.848 0.70704572 0.70704447 -2.9977604e-08 -0.09996259 -0.09996259 -0.09996259 - 28490 2.849 0.70704591 0.70704466 -2.7268788e-08 -0.099962696 -0.099962696 -0.099962696 - 28500 2.85 0.70704609 0.70704485 -2.4234231e-08 -0.099962802 -0.099962802 -0.099962802 - 28510 2.851 0.70704628 0.70704503 -2.0944717e-08 -0.099962907 -0.099962907 -0.099962907 - 28520 2.852 0.70704646 0.70704522 -1.7476677e-08 -0.099963012 -0.099963012 -0.099963012 - 28530 2.853 0.70704665 0.7070454 -1.3910418e-08 -0.099963117 -0.099963117 -0.099963117 - 28540 2.854 0.70704683 0.70704559 -1.0328262e-08 -0.099963221 -0.099963221 -0.099963221 - 28550 2.855 0.70704701 0.70704577 -6.8126461e-09 -0.099963325 -0.099963325 -0.099963325 - 28560 2.856 0.7070472 0.70704595 -3.4442292e-09 -0.099963428 -0.099963428 -0.099963428 - 28570 2.857 0.70704738 0.70704614 -3.0003878e-10 -0.099963532 -0.099963532 -0.099963532 - 28580 2.858 0.70704757 0.70704632 2.5482883e-09 -0.099963635 -0.099963635 -0.099963635 - 28590 2.859 0.70704775 0.7070465 5.036137e-09 -0.099963737 -0.099963737 -0.099963737 - 28600 2.86 0.70704793 0.70704667 7.1073792e-09 -0.09996384 -0.09996384 -0.09996384 - 28610 2.861 0.70704811 0.70704685 8.715639e-09 -0.099963942 -0.099963942 -0.099963942 - 28620 2.862 0.7070483 0.70704703 9.8253296e-09 -0.099964043 -0.099964043 -0.099964043 - 28630 2.863 0.70704848 0.70704721 1.0412439e-08 -0.099964145 -0.099964145 -0.099964145 - 28640 2.864 0.70704866 0.70704738 1.0465049e-08 -0.099964246 -0.099964246 -0.099964246 - 28650 2.865 0.70704884 0.70704756 9.9835685e-09 -0.099964347 -0.099964347 -0.099964347 - 28660 2.866 0.70704902 0.70704773 8.9806913e-09 -0.099964447 -0.099964447 -0.099964447 - 28670 2.867 0.7070492 0.70704791 7.4810643e-09 -0.099964548 -0.099964548 -0.099964548 - 28680 2.868 0.70704938 0.70704808 5.5206852e-09 -0.099964647 -0.099964647 -0.099964647 - 28690 2.869 0.70704956 0.70704826 3.1460399e-09 -0.099964747 -0.099964747 -0.099964747 - 28700 2.87 0.70704973 0.70704843 4.1300166e-10 -0.099964846 -0.099964846 -0.099964846 - 28710 2.871 0.70704991 0.70704861 -2.6144825e-09 -0.099964945 -0.099964945 -0.099964945 - 28720 2.872 0.70705009 0.70704878 -5.8658871e-09 -0.099965044 -0.099965044 -0.099965044 - 28730 2.873 0.70705026 0.70704895 -9.2657502e-09 -0.099965142 -0.099965142 -0.099965142 - 28740 2.874 0.70705043 0.70704913 -1.2735424e-08 -0.099965241 -0.099965241 -0.099965241 - 28750 2.875 0.70705061 0.7070493 -1.6194893e-08 -0.099965338 -0.099965338 -0.099965338 - 28760 2.876 0.70705078 0.70704947 -1.956462e-08 -0.099965436 -0.099965436 -0.099965436 - 28770 2.877 0.70705095 0.70704964 -2.2767372e-08 -0.099965533 -0.099965533 -0.099965533 - 28780 2.878 0.70705112 0.70704982 -2.572999e-08 -0.09996563 -0.09996563 -0.09996563 - 28790 2.879 0.70705129 0.70704999 -2.8385063e-08 -0.099965727 -0.099965727 -0.099965727 - 28800 2.88 0.70705146 0.70705016 -3.0672454e-08 -0.099965823 -0.099965823 -0.099965823 - 28810 2.881 0.70705162 0.70705033 -3.2540668e-08 -0.099965919 -0.099965919 -0.099965919 - 28820 2.882 0.70705179 0.70705051 -3.3948006e-08 -0.099966015 -0.099966015 -0.099966015 - 28830 2.883 0.70705196 0.70705068 -3.4863495e-08 -0.09996611 -0.09996611 -0.09996611 - 28840 2.884 0.70705212 0.70705085 -3.5267571e-08 -0.099966205 -0.099966205 -0.099966205 - 28850 2.885 0.70705229 0.70705102 -3.515249e-08 -0.0999663 -0.0999663 -0.0999663 - 28860 2.886 0.70705245 0.70705119 -3.4522473e-08 -0.099966395 -0.099966395 -0.099966395 - 28870 2.887 0.70705262 0.70705136 -3.3393572e-08 -0.099966489 -0.099966489 -0.099966489 - 28880 2.888 0.70705278 0.70705152 -3.1793265e-08 -0.099966583 -0.099966583 -0.099966583 - 28890 2.889 0.70705295 0.70705169 -2.9759789e-08 -0.099966677 -0.099966677 -0.099966677 - 28900 2.89 0.70705311 0.70705186 -2.7341227e-08 -0.09996677 -0.09996677 -0.09996677 - 28910 2.891 0.70705327 0.70705202 -2.4594376e-08 -0.099966863 -0.099966863 -0.099966863 - 28920 2.892 0.70705344 0.70705219 -2.158341e-08 -0.099966956 -0.099966956 -0.099966956 - 28930 2.893 0.7070536 0.70705235 -1.8378384e-08 -0.099967049 -0.099967049 -0.099967049 - 28940 2.894 0.70705376 0.70705252 -1.5053602e-08 -0.099967141 -0.099967141 -0.099967141 - 28950 2.895 0.70705392 0.70705268 -1.1685901e-08 -0.099967233 -0.099967233 -0.099967233 - 28960 2.896 0.70705409 0.70705284 -8.3528678e-09 -0.099967325 -0.099967325 -0.099967325 - 28970 2.897 0.70705425 0.707053 -5.1310606e-09 -0.099967417 -0.099967417 -0.099967417 - 28980 2.898 0.70705441 0.70705316 -2.094245e-09 -0.099967508 -0.099967508 -0.099967508 - 28990 2.899 0.70705457 0.70705332 6.8829132e-10 -0.099967599 -0.099967599 -0.099967599 - 29000 2.9 0.70705474 0.70705348 3.1533193e-09 -0.099967689 -0.099967689 -0.099967689 - 29010 2.901 0.7070549 0.70705364 5.2451044e-09 -0.09996778 -0.09996778 -0.09996778 - 29020 2.902 0.70705506 0.7070538 6.916666e-09 -0.09996787 -0.09996787 -0.09996787 - 29030 2.903 0.70705522 0.70705395 8.1308311e-09 -0.09996796 -0.09996796 -0.09996796 - 29040 2.904 0.70705538 0.70705411 8.8610599e-09 -0.099968049 -0.099968049 -0.099968049 - 29050 2.905 0.70705554 0.70705427 9.0920237e-09 -0.099968139 -0.099968139 -0.099968139 - 29060 2.906 0.7070557 0.70705442 8.8199241e-09 -0.099968228 -0.099968228 -0.099968228 - 29070 2.907 0.70705586 0.70705458 8.0525445e-09 -0.099968316 -0.099968316 -0.099968316 - 29080 2.908 0.70705602 0.70705473 6.8090367e-09 -0.099968405 -0.099968405 -0.099968405 - 29090 2.909 0.70705618 0.70705488 5.1194459e-09 -0.099968493 -0.099968493 -0.099968493 - 29100 2.91 0.70705633 0.70705504 3.0239861e-09 -0.099968581 -0.099968581 -0.099968581 - 29110 2.911 0.70705649 0.70705519 5.720847e-10 -0.099968669 -0.099968669 -0.099968669 - 29120 2.912 0.70705665 0.70705534 -2.1787821e-09 -0.099968756 -0.099968756 -0.099968756 - 29130 2.913 0.7070568 0.7070555 -5.1644361e-09 -0.099968843 -0.099968843 -0.099968843 - 29140 2.914 0.70705695 0.70705565 -8.3154934e-09 -0.09996893 -0.09996893 -0.09996893 - 29150 2.915 0.70705711 0.7070558 -1.1558976e-08 -0.099969017 -0.099969017 -0.099969017 - 29160 2.916 0.70705726 0.70705596 -1.4820001e-08 -0.099969103 -0.099969103 -0.099969103 - 29170 2.917 0.70705741 0.70705611 -1.802351e-08 -0.099969189 -0.099969189 -0.099969189 - 29180 2.918 0.70705756 0.70705626 -2.1095993e-08 -0.099969275 -0.099969275 -0.099969275 - 29190 2.919 0.70705771 0.70705641 -2.396718e-08 -0.09996936 -0.09996936 -0.09996936 - 29200 2.92 0.70705786 0.70705657 -2.657164e-08 -0.099969446 -0.099969446 -0.099969446 - 29210 2.921 0.70705801 0.70705672 -2.8850278e-08 -0.099969531 -0.099969531 -0.099969531 - 29220 2.922 0.70705816 0.70705687 -3.0751671e-08 -0.099969616 -0.099969616 -0.099969616 - 29230 2.923 0.70705831 0.70705702 -3.223323e-08 -0.0999697 -0.0999697 -0.0999697 - 29240 2.924 0.70705845 0.70705717 -3.326215e-08 -0.099969784 -0.099969784 -0.099969784 - 29250 2.925 0.7070586 0.70705732 -3.3816138e-08 -0.099969868 -0.099969868 -0.099969868 - 29260 2.926 0.70705875 0.70705747 -3.3883892e-08 -0.099969952 -0.099969952 -0.099969952 - 29270 2.927 0.70705889 0.70705762 -3.3465328e-08 -0.099970036 -0.099970036 -0.099970036 - 29280 2.928 0.70705904 0.70705777 -3.2571548e-08 -0.099970119 -0.099970119 -0.099970119 - 29290 2.929 0.70705918 0.70705792 -3.1224549e-08 -0.099970202 -0.099970202 -0.099970202 - 29300 2.93 0.70705933 0.70705807 -2.945669e-08 -0.099970285 -0.099970285 -0.099970285 - 29310 2.931 0.70705947 0.70705822 -2.7309908e-08 -0.099970367 -0.099970367 -0.099970367 - 29320 2.932 0.70705961 0.70705836 -2.4834729e-08 -0.09997045 -0.09997045 -0.09997045 - 29330 2.933 0.70705976 0.70705851 -2.2089082e-08 -0.099970532 -0.099970532 -0.099970532 - 29340 2.934 0.7070599 0.70705866 -1.9136938e-08 -0.099970613 -0.099970613 -0.099970613 - 29350 2.935 0.70706005 0.7070588 -1.6046826e-08 -0.099970695 -0.099970695 -0.099970695 - 29360 2.936 0.70706019 0.70705894 -1.2890239e-08 -0.099970776 -0.099970776 -0.099970776 - 29370 2.937 0.70706033 0.70705909 -9.7399839e-09 -0.099970857 -0.099970857 -0.099970857 - 29380 2.938 0.70706048 0.70705923 -6.6685e-09 -0.099970938 -0.099970938 -0.099970938 - 29390 2.939 0.70706062 0.70705937 -3.7461955e-09 -0.099971018 -0.099971018 -0.099971018 - 29400 2.94 0.70706076 0.70705951 -1.039834e-09 -0.099971099 -0.099971099 -0.099971099 - 29410 2.941 0.7070609 0.70705965 1.3889902e-09 -0.099971179 -0.099971179 -0.099971179 - 29420 2.942 0.70706105 0.70705979 3.4852534e-09 -0.099971258 -0.099971258 -0.099971258 - 29430 2.943 0.70706119 0.70705993 5.2017475e-09 -0.099971338 -0.099971338 -0.099971338 - 29440 2.944 0.70706133 0.70706007 6.5001432e-09 -0.099971417 -0.099971417 -0.099971417 - 29450 2.945 0.70706147 0.70706021 7.3518435e-09 -0.099971496 -0.099971496 -0.099971496 - 29460 2.946 0.70706162 0.70706034 7.7386129e-09 -0.099971575 -0.099971575 -0.099971575 - 29470 2.947 0.70706176 0.70706048 7.652965e-09 -0.099971654 -0.099971654 -0.099971654 - 29480 2.948 0.7070619 0.70706062 7.0983021e-09 -0.099971732 -0.099971732 -0.099971732 - 29490 2.949 0.70706204 0.70706075 6.0888041e-09 -0.09997181 -0.09997181 -0.09997181 - 29500 2.95 0.70706218 0.70706089 4.6490695e-09 -0.099971888 -0.099971888 -0.099971888 - 29510 2.951 0.70706232 0.70706102 2.8135184e-09 -0.099971966 -0.099971966 -0.099971966 - 29520 2.952 0.70706245 0.70706116 6.2557025e-10 -0.099972043 -0.099972043 -0.099972043 - 29530 2.953 0.70706259 0.70706129 -1.8633811e-09 -0.09997212 -0.09997212 -0.09997212 - 29540 2.954 0.70706273 0.70706143 -4.5951746e-09 -0.099972197 -0.099972197 -0.099972197 - 29550 2.955 0.70706287 0.70706156 -7.5062397e-09 -0.099972274 -0.099972274 -0.099972274 - 29560 2.956 0.707063 0.7070617 -1.0529075e-08 -0.099972351 -0.099972351 -0.099972351 - 29570 2.957 0.70706314 0.70706183 -1.3593813e-08 -0.099972427 -0.099972427 -0.099972427 - 29580 2.958 0.70706327 0.70706197 -1.6629835e-08 -0.099972503 -0.099972503 -0.099972503 - 29590 2.959 0.7070634 0.7070621 -1.9567396e-08 -0.099972579 -0.099972579 -0.099972579 - 29600 2.96 0.70706354 0.70706224 -2.2339227e-08 -0.099972654 -0.099972654 -0.099972654 - 29610 2.961 0.70706367 0.70706237 -2.4882075e-08 -0.099972729 -0.099972729 -0.099972729 - 29620 2.962 0.7070638 0.70706251 -2.7138147e-08 -0.099972805 -0.099972805 -0.099972805 - 29630 2.963 0.70706393 0.70706264 -2.9056419e-08 -0.099972879 -0.099972879 -0.099972879 - 29640 2.964 0.70706406 0.70706277 -3.0593794e-08 -0.099972954 -0.099972954 -0.099972954 - 29650 2.965 0.70706419 0.70706291 -3.1716065e-08 -0.099973028 -0.099973028 -0.099973028 - 29660 2.966 0.70706432 0.70706304 -3.2398677e-08 -0.099973103 -0.099973103 -0.099973103 - 29670 2.967 0.70706445 0.70706317 -3.2627263e-08 -0.099973177 -0.099973177 -0.099973177 - 29680 2.968 0.70706458 0.7070633 -3.2397941e-08 -0.09997325 -0.09997325 -0.09997325 - 29690 2.969 0.7070647 0.70706344 -3.1717375e-08 -0.099973324 -0.099973324 -0.099973324 - 29700 2.97 0.70706483 0.70706357 -3.0602587e-08 -0.099973397 -0.099973397 -0.099973397 - 29710 2.971 0.70706496 0.7070637 -2.9080536e-08 -0.09997347 -0.09997347 -0.09997347 - 29720 2.972 0.70706509 0.70706383 -2.7187465e-08 -0.099973543 -0.099973543 -0.099973543 - 29730 2.973 0.70706521 0.70706396 -2.4968041e-08 -0.099973616 -0.099973616 -0.099973616 - 29740 2.974 0.70706534 0.70706409 -2.2474306e-08 -0.099973688 -0.099973688 -0.099973688 - 29750 2.975 0.70706547 0.70706422 -1.9764448e-08 -0.09997376 -0.09997376 -0.09997376 - 29760 2.976 0.70706559 0.70706435 -1.6901455e-08 -0.099973832 -0.099973832 -0.099973832 - 29770 2.977 0.70706572 0.70706447 -1.3951642e-08 -0.099973904 -0.099973904 -0.099973904 - 29780 2.978 0.70706585 0.7070646 -1.0983123e-08 -0.099973975 -0.099973975 -0.099973975 - 29790 2.979 0.70706597 0.70706472 -8.0642345e-09 -0.099974047 -0.099974047 -0.099974047 - 29800 2.98 0.7070661 0.70706485 -5.2619636e-09 -0.099974118 -0.099974118 -0.099974118 - 29810 2.981 0.70706623 0.70706497 -2.6404129e-09 -0.099974189 -0.099974189 -0.099974189 - 29820 2.982 0.70706635 0.7070651 -2.593337e-10 -0.099974259 -0.099974259 -0.099974259 - 29830 2.983 0.70706648 0.70706522 1.8272352e-09 -0.09997433 -0.09997433 -0.09997433 - 29840 2.984 0.7070666 0.70706534 3.5721929e-09 -0.0999744 -0.0999744 -0.0999744 - 29850 2.985 0.70706673 0.70706547 4.9364389e-09 -0.09997447 -0.09997447 -0.09997447 - 29860 2.986 0.70706685 0.70706559 5.889748e-09 -0.09997454 -0.09997454 -0.09997454 - 29870 2.987 0.70706698 0.70706571 6.4114388e-09 -0.09997461 -0.09997461 -0.09997461 - 29880 2.988 0.7070671 0.70706583 6.4908206e-09 -0.099974679 -0.099974679 -0.099974679 - 29890 2.989 0.70706723 0.70706595 6.1274086e-09 -0.099974748 -0.099974748 -0.099974748 - 29900 2.99 0.70706735 0.70706607 5.3309045e-09 -0.099974817 -0.099974817 -0.099974817 - 29910 2.991 0.70706748 0.70706619 4.120942e-09 -0.099974886 -0.099974886 -0.099974886 - 29920 2.992 0.7070676 0.70706631 2.5266059e-09 -0.099974954 -0.099974954 -0.099974954 - 29930 2.993 0.70706772 0.70706643 5.8573349e-10 -0.099975023 -0.099975023 -0.099975023 - 29940 2.994 0.70706784 0.70706655 -1.6559816e-09 -0.099975091 -0.099975091 -0.099975091 - 29950 2.995 0.70706796 0.70706666 -4.1460645e-09 -0.099975159 -0.099975159 -0.099975159 - 29960 2.996 0.70706808 0.70706678 -6.8264867e-09 -0.099975227 -0.099975227 -0.099975227 - 29970 2.997 0.7070682 0.7070669 -9.6350175e-09 -0.099975294 -0.099975294 -0.099975294 - 29980 2.998 0.70706832 0.70706702 -1.2506668e-08 -0.099975361 -0.099975361 -0.099975361 - 29990 2.999 0.70706844 0.70706714 -1.5375195e-08 -0.099975428 -0.099975428 -0.099975428 - 30000 3 0.70706856 0.70706726 -1.8174628e-08 -0.099975495 -0.099975495 -0.099975495 diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat b/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat deleted file mode 100644 index 6150a7db80..0000000000 --- a/examples/SPIN/benchmark/benchmarck_damped_exchange/res_llg.dat +++ /dev/null @@ -1,30000 +0,0 @@ -0.0 0.5000379764466908 0.5000379762919002 6.84951750526408e-09 -1.5191124600081537e-05 -0.0001 0.5000759500598655 0.5000759496460607 1.3701761380005562e-08 -3.0382248537374107e-05 -0.0002 0.5001139208384794 0.5001139200613359 2.055593812527734e-08 -4.557337111074589e-05 -0.00030000000000000003 0.5001518887814818 0.500151887536587 2.741125297925362e-08 -6.076449161906539e-05 -0.0004 0.5001898538878166 0.5001898520706807 3.4266909972741066e-08 -7.595560936120119e-05 -0.0005 0.5002278161564215 0.5002278136624908 4.112211205234417e-08 -9.114672363602262e-05 -0.0006000000000000001 0.5002657755862286 0.5002657723108973 4.797606118628339e-08 -0.00010633783374239962 -0.0007000000000000001 0.5003037321761644 0.5003037280147862 5.482795840255905e-08 -0.00012152893897920281 -0.0008 0.5003416859251496 0.5003416807730506 6.167700394854592e-08 -0.00013672003864530422 -0.0009 0.5003796368320985 0.5003796305845891 6.852239733262655e-08 -0.00015191113203957588 -0.001 0.5004175848959201 0.5004175774483076 7.536333741786638e-08 -0.0001671022184608918 -0.0011 0.5004555301155172 0.5004555213631178 8.219902256773048e-08 -0.00018229329720812675 -0.0012000000000000001 0.500493472489787 0.500493462327938 8.90286507154725e-08 -0.0001974843675801575 -0.0013 0.5005314120176209 0.5005314003416931 9.585141939189024e-08 -0.00021267542887586175 -0.0014000000000000002 0.500569348697904 0.5005693354033143 1.0266652591267578e-07 -0.00022786648039411947 -0.0015 0.5006072825295161 0.5006072675117391 1.0947316744086555e-07 -0.00024305752143381193 -0.0016 0.5006452135113305 0.5006451966659119 1.1627054109786261e-07 -0.0002582485512938229 -0.0017000000000000001 0.5006831416422151 0.5006831228647828 1.230578439287422e-07 -0.0002734395692730374 -0.0018 0.5007210669210316 0.5007210461073092 1.2983427324919639e-07 -0.00028863057467034235 -0.0019000000000000002 0.5007589893466361 0.5007589663924545 1.365990265622674e-07 -0.0003038215667846303 -0.002 0.5007969089178788 0.5007968837191885 1.4335130162079768e-07 -0.00031901254491479084 -0.0021000000000000003 0.5008348256336034 0.500834798086488 1.5009029664947438e-07 -0.0003342035083597185 -0.0022 0.5008727394926485 0.5008727094933357 1.568152103170739e-07 -0.0003493944564183151 -0.0023000000000000004 0.5009106504938464 0.500910617938721 1.6352524197238427e-07 -0.0003645853883894761 -0.0024000000000000002 0.5009485586360234 0.5009485234216398 1.7021959164420508e-07 -0.0003797763035721096 -0.0025 0.5009864639180001 0.5009864259410943 1.7689746015236985e-07 -0.00039496720126511593 -0.0026 0.5010243663385908 0.5010243254960933 1.8355804921876828e-07 -0.00041015808076741087 -0.0027 0.501062265896605 0.5010622220856524 1.9020056146734632e-07 -0.0004253489413779052 -0.0028000000000000004 0.5011001625908451 0.501100115708793 1.9682420070166184e-07 -0.00044053978239551664 -0.0029000000000000002 0.5011380564201082 0.5011380063645434 2.0342817186325135e-07 -0.00045573060311916437 -0.003 0.5011759473831855 0.5011758940519381 2.100116811842856e-07 -0.000470921402847771 -0.0031 0.501213835478862 0.5012137787700183 2.1657393632634747e-07 -0.0004861121808802681 -0.0032 0.5012517207059172 0.5012516605178317 2.2311414626940973e-07 -0.0005013029365155867 -0.0033000000000000004 0.5012896030631242 0.501289539294432 2.2963152165877965e-07 -0.0005164936690526603 -0.0034000000000000002 0.5013274825492512 0.5013274150988798 2.361252747495879e-07 -0.000531684377790427 -0.0035 0.5013653591630596 0.5013652879302418 2.425946195316886e-07 -0.0005468750620278379 -0.0036 0.5014032329033056 0.5014031577875914 2.4903877196558177e-07 -0.0005620657210638397 -0.0037 0.5014411037687392 0.5014410246700081 2.5545694984363543e-07 -0.0005772563541973822 -0.0038000000000000004 0.5014789717581046 0.5014788885765783 2.6184837312315246e-07 -0.0005924469607274316 -0.0039000000000000003 0.5015168368701405 0.5015167495063941 2.6821226367657047e-07 -0.000607637539952946 -0.004 0.5015546991035795 0.5015546074585543 2.7454784581881775e-07 -0.0006228280911729001 -0.0041 0.5015925584571485 0.501592462432164 2.8085434605751303e-07 -0.0006380186136862546 -0.004200000000000001 0.5016304149295687 0.5016303144263348 2.87130993259499e-07 -0.000653209106791998 -0.0043 0.5016682685195559 0.5016681634401846 2.933770190116647e-07 -0.0006683995697891146 -0.0044 0.5017061192258192 0.5017060094728374 2.9959165737114546e-07 -0.0006835900019765903 -0.0045 0.5017439670470629 0.5017438525234236 3.0577414528165647e-07 -0.0006987804026534275 -0.004600000000000001 0.5017818119819851 0.5017816925910799 3.119237222126703e-07 -0.0007139707711186244 -0.0047 0.5018196540292785 0.5018195296749492 3.1803963071452834e-07 -0.0007291611066711835 -0.0048000000000000004 0.5018574931876301 0.5018573637741811 3.241211161686408e-07 -0.0007443514086101222 -0.004900000000000001 0.5018953294557208 0.5018951948879307 3.301674271760646e-07 -0.0007595416762344626 -0.005 0.5019331628322267 0.5019330230153597 3.361778155297479e-07 -0.0007747319088432236 -0.0051 0.5019709933158175 0.501970848155636 3.4215153615901883e-07 -0.0007899221057354466 -0.0052 0.502008820905158 0.5020086703079335 3.480878474904081e-07 -0.0008051122662101701 -0.005300000000000001 0.502046645598907 0.5020464894714324 3.539860113088711e-07 -0.0008203023895664214 -0.0054 0.5020844673957175 0.5020843056453191 3.5984529297983237e-07 -0.0008354924751032861 -0.0055 0.5021222862942378 0.5021221188287859 3.6566496142143023e-07 -0.0008506825221197972 -0.005600000000000001 0.5021601022931099 0.5021599290210311 3.7144428943758356e-07 -0.0008658725299150239 -0.0057 0.502197915390971 0.5021977362212594 3.771825536069695e-07 -0.0008810624977880571 -0.0058000000000000005 0.5022357255864521 0.5022355404286812 3.828790343940458e-07 -0.0008962524250379661 -0.005900000000000001 0.5022735328781794 0.5022733416425131 3.8853301617680636e-07 -0.0009114423109638337 -0.006 0.5023113372647737 0.5023111398619776 3.94143787718626e-07 -0.0009266321548647678 -0.0061 0.5023491387448502 0.5023489350863032 3.9971064150212676e-07 -0.0009418219560398622 -0.0062 0.5023869373170187 0.5023867273147241 4.052328746451117e-07 -0.0009570117137882334 -0.006300000000000001 0.502424732979884 0.5024245165464805 4.1070978862300933e-07 -0.0009722014274090086 -0.0064 0.5024625257320453 0.5024623027808185 4.1614068932438464e-07 -0.0009873910962013067 -0.0065 0.5025003155720967 0.5025000860169901 4.2152488693991685e-07 -0.0010025807194642606 -0.006600000000000001 0.5025381024986275 0.5025378662542531 4.268616965730221e-07 -0.0010177702964970226 -0.0067 0.5025758865102209 0.5025756434918709 4.321504380178087e-07 -0.0010329598265987477 -0.0068000000000000005 0.5026136676054558 0.5026134177291126 4.3739043584234416e-07 -0.0010481493090685968 -0.006900000000000001 0.5026514457829057 0.5026511889652533 4.4258101944416595e-07 -0.0010633387432057524 -0.007 0.502689221041139 0.5026889571995735 4.477215231335485e-07 -0.0010785281283093695 -0.0071 0.5027269933787187 0.5027267224313595 4.528112866886147e-07 -0.001093717463678645 -0.0072 0.5027647627942033 0.502764484659903 4.5784965455042403e-07 -0.0011089067486127868 -0.007300000000000001 0.5028025292861467 0.5028022438845013 4.628359765446177e-07 -0.0011240959824109999 -0.0074 0.5028402928530964 0.5028400001044574 4.677696081589744e-07 -0.0011392851643724834 -0.0075 0.5028780534935967 0.5028777533190797 4.72649909766254e-07 -0.0011544742937964925 -0.007600000000000001 0.5029158112061859 0.502915503527682 4.774762473735983e-07 -0.0011696633699822378 -0.0077 0.5029535659893982 0.5029532507295834 4.822479927613088e-07 -0.0011848523922289745 -0.0078000000000000005 0.5029913178417623 0.5029909949241087 4.86964523538358e-07 -0.0012000413598359683 -0.0079 0.5030290667618027 0.5030287361105875 4.916252225317663e-07 -0.0012152302721024468 -0.008 0.503066812748039 0.5030664742883553 4.9622947861927e-07 -0.0012304191283277256 -0.0081 0.5031045557989864 0.5031042094567524 5.007766866738095e-07 -0.001245607927811099 -0.0082 0.5031422959131552 0.5031419416151245 5.052662474525071e-07 -0.0012607966698518491 -0.0083 0.5031800330890511 0.5031796707628224 5.096975677076898e-07 -0.001275985353749265 -0.008400000000000001 0.5032177673251754 0.5032173968992021 5.140700606309778e-07 -0.0012911739788026679 -0.0085 0.503255498620025 0.5032551200236246 5.183831452981735e-07 -0.0013063625443114236 -0.0086 0.5032932269720921 0.5032928401354558 5.226362471688617e-07 -0.0013215510495748319 -0.008700000000000001 0.5033309523798648 0.503330557234067 5.268287981974318e-07 -0.0013367394938922585 -0.0088 0.5033686748418266 0.5033682713188341 5.309602367775668e-07 -0.0013519278765630528 -0.0089 0.5034063943564568 0.5034059823891377 5.35030007686732e-07 -0.0013671161968866197 -0.009 0.5034441109222307 0.5034436904443637 5.390375623637311e-07 -0.0013823044541623087 -0.0091 0.5034818245376188 0.5034813954839025 5.429823591307503e-07 -0.0013974926476895467 -0.009200000000000002 0.5035195352010882 0.5035190975071494 5.468638628602918e-07 -0.0014126807767677275 -0.009300000000000001 0.5035572429111012 0.5035567965135043 5.50681545197218e-07 -0.0014278688406962727 -0.0094 0.5035949476661163 0.5035944925023718 5.544348846142633e-07 -0.0014430568387746147 -0.0095 0.5036326494645884 0.5036321854731611 5.581233668561225e-07 -0.0014582447703021973 -0.009600000000000001 0.5036703483049679 0.503669875425286 5.617464846618958e-07 -0.0014734326345785089 -0.0097 0.5037080441857014 0.5037075623581647 5.653037375985548e-07 -0.0014886204309029428 -0.009800000000000001 0.503745737105232 0.50374524627122 5.687946325605431e-07 -0.0015038081585750486 -0.0099 0.5037834270619984 0.5037829271638787 5.722186838807986e-07 -0.001518995816894303 -0.01 0.503821114054436 0.5038206050355727 5.755754131087087e-07 -0.0015341834051602167 -0.010100000000000001 0.5038587980809763 0.5038582798857371 5.788643489545997e-07 -0.0015493709226723107 -0.0102 0.5038964791400475 0.5038959517138121 5.820850278448475e-07 -0.0015645583687300846 -0.0103 0.5039341572300742 0.5039336205192418 5.852369937553448e-07 -0.0015797457426331041 -0.0104 0.5039718323494766 0.5039712863014745 5.883197977674115e-07 -0.0015949330436809462 -0.0105 0.5040095044966726 0.5040089490599624 5.913329992890404e-07 -0.001610120271173199 -0.010600000000000002 0.5040471736700761 0.504046608794162 5.942761648891626e-07 -0.0016253074244094114 -0.010700000000000001 0.5040848398680976 0.5040842655035332 5.971488692968485e-07 -0.0016404945026891828 -0.0108 0.5041225030891443 0.5041219191875406 5.999506948461963e-07 -0.00165568150531214 -0.0109 0.5041601633316206 0.5041595698456518 6.026812319759323e-07 -0.0016708684315779267 -0.011 0.5041978205939273 0.5041972174773388 6.053400787853214e-07 -0.001686055280786153 -0.011100000000000002 0.5042354748744621 0.5042348620820769 6.079268418113237e-07 -0.0017012420522364959 -0.011200000000000002 0.5042731261716198 0.5042725036593453 6.104411350849048e-07 -0.0017164287452286376 -0.011300000000000001 0.5043107744837922 0.5043101422086269 6.128825813522809e-07 -0.0017316153590622553 -0.0114 0.504348419809368 0.5043477777294076 6.152508109091848e-07 -0.0017468018930370422 -0.0115 0.5043860621467331 0.5043854102211777 6.175454629886445e-07 -0.0017619883464527033 -0.011600000000000001 0.5044237014942708 0.50442303968343 6.197661845952496e-07 -0.0017771747186089704 -0.0117 0.5044613378503613 0.5044606661156613 6.219126316153734e-07 -0.0017923610088056265 -0.011800000000000001 0.5044989712133822 0.504498289517371 6.239844677069506e-07 -0.0018075472163423868 -0.0119 0.5045366015817084 0.5045359098880625 6.259813652431667e-07 -0.0018227333405190394 -0.012 0.5045742289537126 0.504573527227242 6.279030053679691e-07 -0.0018379193806353723 -0.012100000000000001 0.5046118533277648 0.5046111415344187 6.297490774409553e-07 -0.0018531053359911844 -0.0122 0.5046494747022323 0.504648752809105 6.315192797035074e-07 -0.0018682912058863245 -0.0123 0.5046870930754804 0.5046863610508161 6.332133188347022e-07 -0.001883476989620625 -0.0124 0.504724708445872 0.5047239662590703 6.348309100068228e-07 -0.001898662686493935 -0.0125 0.5047623208117675 0.5047615684333888 6.363717775514921e-07 -0.0019138482958060866 -0.012600000000000002 0.5047999301715257 0.5047991675732953 6.378356546266062e-07 -0.001929033816857012 -0.012700000000000001 0.5048375365235026 0.5048367636783166 6.392222830498007e-07 -0.0019442192489466216 -0.0128 0.5048751398660524 0.5048743567479816 6.405314133539619e-07 -0.0019594045913747583 -0.0129 0.5049127401975279 0.5049119467818225 6.417628054533608e-07 -0.0019745898434414435 -0.013 0.504950337516279 0.5049495337793731 6.429162275889411e-07 -0.001989775004446598 -0.013100000000000002 0.5049879318206546 0.5049871177401704 6.439914574385419e-07 -0.002004960073690171 -0.013200000000000002 0.5050255231090014 0.5050246986637534 6.449882816728092e-07 -0.002020145050472155 -0.013300000000000001 0.5050631113796643 0.5050622765496636 6.459064960107064e-07 -0.0020353299340925557 -0.0134 0.5051006966309872 0.5050998513974447 6.467459052195146e-07 -0.00205051472385141 -0.0135 0.5051382788613117 0.5051374232066421 6.475063234478995e-07 -0.0020656994190487166 -0.013600000000000001 0.5051758580689784 0.5051749919768044 6.481875737818221e-07 -0.0020808840189845803 -0.0137 0.5052134342523261 0.5052125577074809 6.487894884665835e-07 -0.002096068522958994 -0.013800000000000002 0.5052510074096925 0.5052501203982239 6.493119092954025e-07 -0.0021112529302721008 -0.013900000000000001 0.5052885775394143 0.5052876800485872 6.497546871098159e-07 -0.002126437240224016 -0.014 0.5053261446398263 0.505325236658126 6.501176822992782e-07 -0.0021416214521148727 -0.014100000000000001 0.5053637087092628 0.5053627902263977 6.504007644680954e-07 -0.002156805565244785 -0.0142 0.5054012697460566 0.5054003407529617 6.506038123799129e-07 -0.0021719895789139134 -0.0143 0.5054388277485398 0.5054378882373783 6.507267145683393e-07 -0.0021871734924224285 -0.0144 0.505476382715043 0.5054754326792098 6.507693689483673e-07 -0.002202357305070568 -0.0145 0.505513934643897 0.5055129740780198 6.507316825388187e-07 -0.002217541016158514 -0.014600000000000002 0.5055514835334309 0.5055505124333729 6.506135721284778e-07 -0.002232724624986493 -0.014700000000000001 0.5055890293819734 0.5055880477448359 6.504149641650692e-07 -0.0022479081308548142 -0.0148 0.5056265721878528 0.505625580011976 6.501357940336128e-07 -0.002263091533063655 -0.0149 0.5056641119493965 0.5056631092343621 6.497760072776693e-07 -0.0022782748309134126 -0.015 0.5057016486649315 0.505700635411564 6.493355589887173e-07 -0.0022934580237043757 -0.0151 0.5057391823327847 0.5057381585431525 6.488144130845086e-07 -0.00230864111073687 -0.015200000000000002 0.505776712951282 0.5057756786286993 6.482125440299136e-07 -0.0023238240913111942 -0.015300000000000001 0.5058142405187497 0.505813195667777 6.475299355046538e-07 -0.0023390069647277636 -0.0154 0.5058517650335135 0.5058507096599593 6.467665805698353e-07 -0.0023541897302869486 -0.0155 0.5058892864938994 0.50588822060482 6.459224822785714e-07 -0.002369372387289209 -0.015600000000000001 0.5059268048982329 0.505925728501934 6.449976531763824e-07 -0.0023845549350348886 -0.015700000000000002 0.5059643202448398 0.5059632333508768 6.439921156342621e-07 -0.00239973737282449 -0.0158 0.5060018325320459 0.5060007351512242 6.429059016821448e-07 -0.002414919699958501 -0.0159 0.5060393417581773 0.5060382339025525 6.417390528423716e-07 -0.0024301019157373983 -0.016 0.5060768479215603 0.5060757296044385 6.404916202962241e-07 -0.0024452840194616634 -0.0161 0.5061143510205215 0.5061132222564588 6.391636651614796e-07 -0.00246046601043185 -0.0162 0.506151851053388 0.5061507118581908 6.37755258214856e-07 -0.0024756478879484956 -0.016300000000000002 0.5061893480184874 0.5061881984092118 6.362664798365003e-07 -0.0024908296513122263 -0.0164 0.5062268419141474 0.506225681909099 6.346974202875444e-07 -0.0025060112998235686 -0.0165 0.5062643327386973 0.5062631623574296 6.330481795435716e-07 -0.002521192832783187 -0.0166 0.5063018204904663 0.5063006397537808 6.313188672391057e-07 -0.002536374249491702 -0.0167 0.5063393051677848 0.5063381140977299 6.295096023345437e-07 -0.002551555549249751 -0.016800000000000002 0.5063767867689837 0.5063755853888532 6.276205143374014e-07 -0.002566736731358016 -0.016900000000000002 0.5064142652923951 0.5064130536267273 6.256517419700458e-07 -0.0025819177951172338 -0.017 0.5064517407363522 0.5064505188109283 6.236034335027618e-07 -0.00259709873982813 -0.0171 0.5064892130991893 0.5064879809410316 6.214757474198862e-07 -0.002612279564791409 -0.0172 0.5065266823792414 0.5065254400166124 6.192688513650957e-07 -0.002627460269307869 -0.0173 0.5065641485748454 0.5065628960372449 6.169829230295854e-07 -0.002642640852678302 -0.017400000000000002 0.5066016116843389 0.5066003490025027 6.146181498190018e-07 -0.0026578213142034847 -0.0175 0.5066390717060617 0.5066377989119587 6.121747287979318e-07 -0.0026730016531842874 -0.0176 0.5066765286383542 0.5066752457651849 6.096528661347911e-07 -0.0026881818689215354 -0.0177 0.5067139824795589 0.5067126895617524 6.070527783785806e-07 -0.002703361960716133 -0.0178 0.5067514332280196 0.5067501303012312 6.043746915707082e-07 -0.0027185419278689784 -0.017900000000000003 0.5067888808820823 0.5067875679831904 6.016188412449885e-07 -0.002733721769680997 -0.018 0.5068263254400942 0.5068250026071978 5.987854725941766e-07 -0.0027489014854531757 -0.0181 0.5068637669004048 0.5068624341728196 5.958748404144565e-07 -0.0027640810744864134 -0.0182 0.5069012052613653 0.5068998626796217 5.92887208883397e-07 -0.00277926053608174 -0.0183 0.5069386405213288 0.5069372881271677 5.898228520040405e-07 -0.0027944398695401995 -0.018400000000000003 0.5069760726786507 0.5069747105150197 5.866820533828587e-07 -0.002809619074162806 -0.0185 0.5070135017316887 0.5070121298427388 5.834651058966855e-07 -0.002824798149250607 -0.018600000000000002 0.5070509276788023 0.5070495461098844 5.801723118592506e-07 -0.00283997709410474 -0.018699999999999998 0.5070883505183537 0.5070869593160139 5.768039835762906e-07 -0.002855155908026291 -0.0188 0.5071257702487071 0.5071243694606832 5.733604420687932e-07 -0.0028703345903164147 -0.018900000000000004 0.5071631868682294 0.507161776543446 5.698420183497532e-07 -0.002885513140276236 -0.019 0.5072006003752901 0.5071991805638548 5.662490522584385e-07 -0.0029006915572069637 -0.019100000000000002 0.5072380107682614 0.5072365815214595 5.625818939036797e-07 -0.0029158698404098183 -0.019200000000000002 0.5072754180455177 0.507273979415808 5.58840901887514e-07 -0.002931047989186042 -0.0193 0.5073128222054364 0.5073113742464463 5.550264443598962e-07 -0.0029462260028368993 -0.0194 0.507350223246398 0.5073487660129179 5.511388991297217e-07 -0.0029614038806636492 -0.0195 0.5073876211667858 0.5073861547147644 5.471786526101141e-07 -0.002976581621967617 -0.019600000000000003 0.5074250159649857 0.5074235403515248 5.431461009286487e-07 -0.0029917592260501336 -0.019700000000000002 0.507462407639387 0.5074609229227356 5.390416489836625e-07 -0.00300693669221257 -0.0198 0.5074997961883821 0.507498302427931 5.348657112214106e-07 -0.0030221140197563114 -0.0199 0.5075371816103665 0.5075356788666427 5.306187106368654e-07 -0.003037291207982773 -0.02 0.507574563903739 0.5075730522383992 5.263010799949619e-07 -0.0030524682561933695 -0.0201 0.5076119430669017 0.5076104225427269 5.219132604983301e-07 -0.003067645163689581 -0.020200000000000003 0.50764931909826 0.5076477897791493 5.174557025644511e-07 -0.003082821929772911 -0.020300000000000002 0.5076866919962233 0.5076851539471865 5.129288653815678e-07 -0.0030979985537448575 -0.0204 0.5077240617592041 0.5077225150463565 5.083332172972632e-07 -0.0031131750349069677 -0.0205 0.5077614283856187 0.5077598730761737 5.036692352633487e-07 -0.003128351372560806 -0.0206 0.5077987918738868 0.5077972280361495 4.989374049468864e-07 -0.00314352756600797 -0.020700000000000003 0.5078361522224323 0.5078345799257924 4.941382210632561e-07 -0.003158703614550085 -0.0208 0.5078735094296827 0.5078719287446075 4.89272186932066e-07 -0.0031738795174888093 -0.020900000000000002 0.5079108634940694 0.5079092744920969 4.843398143661304e-07 -0.0031890552741258016 -0.021 0.5079482144140282 0.5079466171677589 4.79341624115559e-07 -0.0032042308837627654 -0.0211 0.507985562187998 0.5079839567710882 4.7427814486855624e-07 -0.0032194063457014256 -0.021200000000000004 0.5080229068144227 0.5080212933015767 4.6914991452817745e-07 -0.003234581659243552 -0.0213 0.5080602482917502 0.5080586267587127 4.63957479046595e-07 -0.003249756823690919 -0.021400000000000002 0.5080975866184325 0.5080959571419802 4.587013929246986e-07 -0.00326493183834532 -0.0215 0.5081349217929261 0.50813328445086 4.533822187680059e-07 -0.0032801067025086286 -0.0216 0.5081722538136916 0.5081706086848292 4.4800052761972964e-07 -0.003295281415482701 -0.021700000000000004 0.5082095826791945 0.5082079298433609 4.425568985721995e-07 -0.003310455976569421 -0.0218 0.5082469083879042 0.5082452479259241 4.3705191918319564e-07 -0.003325630385070719 -0.021900000000000003 0.5082842309382953 0.508282562931984 4.314861849485929e-07 -0.003340804640288553 -0.022 0.508321550328847 0.5083198748610019 4.2586029935787195e-07 -0.0033559787415248818 -0.0221 0.5083588665580424 0.5083571837124348 4.201748738941191e-07 -0.0033711526880817163 -0.022200000000000004 0.5083961796243707 0.508394489485736 4.144305279230043e-07 -0.0033863264792610955 -0.0223 0.5084334895263249 0.5084317921803538 4.086278887760475e-07 -0.0034015001143650916 -0.022400000000000003 0.5084707962624037 0.5084690917957329 4.0276759152857444e-07 -0.003416673592695804 -0.0225 0.50850809983111 0.5085063883313132 3.9685027869440503e-07 -0.003431846913555331 -0.022600000000000002 0.5085454002309523 0.5085436817865306 3.90876600780965e-07 -0.0034470200762458355 -0.0227 0.5085826974604439 0.5085809721608162 3.848472157896854e-07 -0.003462193080069498 -0.0228 0.5086199915181039 0.5086182594535966 3.7876278916049166e-07 -0.003477365924328524 -0.022900000000000004 0.5086572824024558 0.5086555436642939 3.7262399385507017e-07 -0.0034925386083251605 -0.023 0.5086945701120286 0.5086928247923255 3.6643150994053464e-07 -0.003507711131361663 -0.023100000000000002 0.5087318546453569 0.5087301028371041 3.601860251167821e-07 -0.003522883492740339 -0.023200000000000002 0.5087691360009806 0.5087673777980374 3.538882341336258e-07 -0.003538055691763506 -0.0233 0.5088064141774452 0.5088046496745287 3.4753883879079517e-07 -0.0035532277277335353 -0.0234 0.5088436891733014 0.5088419184659759 3.4113854815998046e-07 -0.003568399599952793 -0.0235 0.5088809609871059 0.5088791841717727 3.3468807822401025e-07 -0.003583571307723729 -0.023600000000000003 0.508918229617421 0.5089164467913067 3.2818815190460704e-07 -0.0035987428503487713 -0.023700000000000002 0.5089554950628142 0.508953706323961 3.21639498812587e-07 -0.0036139142271303937 -0.0238 0.5089927573218593 0.5089909627691142 3.150428552756157e-07 -0.0036290854373711243 -0.0239 0.5090300163931358 0.5090282161261382 3.083989645880081e-07 -0.0036442564803734812 -0.024 0.509067272275229 0.5090654663944013 3.017085763445948e-07 -0.003659427355440047 -0.0241 0.50910452496673 0.5091027135732655 2.9497244682930024e-07 -0.0036745980618734173 -0.024200000000000003 0.509141774466236 0.5091399576620879 2.8819133870983116e-07 -0.0036897685989762327 -0.024300000000000002 0.5091790207723504 0.5091771986602195 2.8136602098216557e-07 -0.0037049389660511467 -0.0244 0.5092162638836829 0.5092144365670069 2.744972688595304e-07 -0.0037201091624008715 -0.0245 0.5092535037988484 0.5092516713817904 2.675858636058681e-07 -0.0037352791873281155 -0.0246 0.5092907405164687 0.5092889031039051 2.606325927856368e-07 -0.003750449040135641 -0.024700000000000003 0.5093279740351722 0.5093261317326803 2.5363825001400997e-07 -0.0037656187201262434 -0.0248 0.5093652043535926 0.5093633572674394 2.46603634485032e-07 -0.0037807882266027385 -0.024900000000000002 0.5094024314703709 0.5094005797075007 2.395295513879514e-07 -0.0037959575588679823 -0.025 0.5094396553841539 0.5094377990521767 2.32416811657421e-07 -0.003811126716224862 -0.0251 0.5094768760935952 0.5094750153007733 2.2526623191798656e-07 -0.003826295697976295 -0.025200000000000004 0.5095140935973547 0.5095122284525915 2.1807863409550876e-07 -0.0038414645034252253 -0.0253 0.5095513078940985 0.5095494385069257 2.1085484586125247e-07 -0.0038566331318746444 -0.025400000000000002 0.5095885189825001 0.5095866454630649 2.0359569996575289e-07 -0.00387180158262756 -0.0255 0.5096257268612391 0.5096238493202916 1.9630203476617147e-07 -0.0038869698549870244 -0.0256 0.5096629315290017 0.5096610500778824 1.8897469337975092e-07 -0.0039021379482561155 -0.025700000000000004 0.5097001329844811 0.5096982477351083 1.8161452421117108e-07 -0.003917305861737952 -0.0258 0.5097373312263773 0.5097354422912335 1.742223806611154e-07 -0.003932473594735679 -0.025900000000000003 0.5097745262533968 0.5097726337455162 1.6679912086259296e-07 -0.003947641146552474 -0.026 0.5098117180642531 0.5098098220972088 1.5934560784747198e-07 -0.003962808516491553 -0.0261 0.5098489066576667 0.509847007345557 1.5186270928280177e-07 -0.003977975703856162 -0.026200000000000005 0.5098860920323648 0.5098841894898002 1.443512974291794e-07 -0.003993142707949577 -0.0263 0.5099232741870819 0.5099213685291719 1.368122489603385e-07 -0.004008309528075119 -0.026400000000000003 0.5099604531205595 0.5099585444628988 1.2924644497702698e-07 -0.0040234761635361375 -0.0265 0.5099976288315455 0.5099957172902013 1.2165477086822918e-07 -0.0040386426136360095 -0.026600000000000002 0.5100348013187956 0.5100328870102935 1.1403811608912129e-07 -0.004053808877678154 -0.0267 0.5100719705810725 0.5100700536223829 1.0639737425821583e-07 -0.004068974954966024 -0.0268 0.5101091366171457 0.5101072171256704 9.873344297695041e-08 -0.004084140844803098 -0.026900000000000004 0.5101462994257925 0.5101443775193506 9.104722360764317e-08 -0.004099306546492903 -0.027 0.510183459005797 0.5101815348026113 8.333962135675943e-08 -0.004114472059338988 -0.027100000000000003 0.5102206153559505 0.5102186889746335 7.561154506674495e-08 -0.004129637382644944 -0.027200000000000002 0.510257768475052 0.5102558400345921 6.786390701479794e-08 -0.004144802515714394 -0.0273 0.5102949183619073 0.5102929879816549 6.009762303083033e-08 -0.004159967457850998 -0.0274 0.5103320650153302 0.5103301328149829 5.231361226848419e-08 -0.004175132208358449 -0.0275 0.5103692084341415 0.5103672745337305 4.451279703859834e-08 -0.00419029676654048 -0.027600000000000003 0.5104063486171689 0.5104044131370453 3.669610273981938e-08 -0.004205461131700849 -0.027700000000000002 0.5104434855632487 0.5104415486240684 2.886445787941838e-08 -0.00422062530314336 -0.027800000000000002 0.5104806192712241 0.5104786809939336 2.1018793781857337e-08 -0.0042357892801718495 -0.0279 0.5105177497399453 0.510515810245768 1.3160044574911378e-08 -0.004250953062090188 -0.028 0.5105548769682711 0.5105529363786919 5.289147037013109e-09 -0.004266116648202283 -0.0281 0.510592000955067 0.5105900593918188 -2.5929594998919114e-09 -0.004281280037812079 -0.028200000000000003 0.5106291216992064 0.5106271792842546 -1.0485333219734105e-08 -0.004296443230223556 -0.028300000000000002 0.5106662391995702 0.5106642960550993 -1.8387029999261673e-08 -0.00431160622474073 -0.0284 0.5107033534550472 0.5107014097034449 -2.62971034531434e-08 -0.004326769020667652 -0.0285 0.5107404644645338 0.5107385202283771 -3.421460514733965e-08 -0.004341931617308414 -0.0286 0.5107775722269335 0.5107756276289742 -4.213858461124542e-08 -0.004357094013967139 -0.028700000000000003 0.5108146767411582 0.5108127319043076 -5.006808949294811e-08 -0.004372256209947991 -0.0288 0.5108517780061274 0.510849833053442 -5.800216568239286e-08 -0.004387418204555171 -0.028900000000000002 0.5108888760207677 0.5108869310754341 -6.5939857405925e-08 -0.004402579997092914 -0.029 0.5109259707840144 0.5109240259693345 -7.388020735899642e-08 -0.004417741586865495 -0.0291 0.5109630622948097 0.5109611177341857 -8.182225680331001e-08 -0.0044329029731772236 -0.029200000000000004 0.5110001505521043 0.5109982063690236 -8.976504570559762e-08 -0.004448064155332447 -0.0293 0.5110372355548563 0.5110352918728773 -9.770761282348883e-08 -0.0044632251326355565 -0.029400000000000003 0.5110743173020315 0.5110723742447681 -1.0564899585729925e-07 -0.0044783859043909715 -0.0295 0.5111113957926039 0.5111094534837105 -1.1358823152549102e-07 -0.0044935464699031565 -0.0296 0.5111484710255548 0.5111465295887115 -1.215243557207979e-07 -0.004508706828476608 -0.029700000000000004 0.5111855429998741 0.5111836025587717 -1.2945640359696142e-07 -0.004523866979415867 -0.0298 0.5112226117145588 0.5112206723928834 -1.3738340971791718e-07 -0.004539026922025509 -0.029900000000000003 0.5112596771686144 0.5112577390900322 -1.4530440813065315e-07 -0.004554186655610147 -0.03 0.5112967393610537 0.5112948026491968 -1.532184324970487e-07 -0.004569346179474434 -0.030100000000000002 0.5113337982908978 0.511331863069348 -1.6112451631938862e-07 -0.004584505492923062 -0.0302 0.5113708539571754 0.5113689203494497 -1.6902169282934087e-07 -0.004599664595260761 -0.0303 0.5114079063589235 0.5114059744884589 -1.7690899534184013e-07 -0.004614823485792299 -0.030400000000000003 0.5114449554951865 0.5114430254853245 -1.8478545724120998e-07 -0.004629982163822486 -0.0305 0.5114820013650172 0.5114800733389891 -1.926501120852464e-07 -0.004645140628656167 -0.030600000000000002 0.5115190439674758 0.5115171180483874 -2.0050199381338452e-07 -0.00466029887959823 -0.0307 0.5115560833016309 0.5115541596124469 -2.0834013683690422e-07 -0.0046754569159535965 -0.0308 0.5115931193665587 0.5115911980300882 -2.1616357610831916e-07 -0.004690614737027235 -0.030900000000000004 0.5116301521613434 0.5116282333002243 -2.2397134728791013e-07 -0.004705772342124151 -0.031 0.5116671816850771 0.5116652654217612 -2.3176248686862522e-07 -0.004720929730549388 -0.031100000000000003 0.5117042079368596 0.5117022943935973 -2.395360322315909e-07 -0.004736086901608029 -0.031200000000000002 0.511741230915799 0.5117393202146239 -2.4729102188203456e-07 -0.004751243854605199 -0.0313 0.5117782506210112 0.5117763428837255 -2.5502649542152867e-07 -0.0047664005888460636 -0.031400000000000004 0.5118152670516196 0.5118133623997785 -2.627414937284023e-07 -0.004781557103635826 -0.0315 0.5118522802067563 0.5118503787616527 -2.704350591797855e-07 -0.0047967133982797314 -0.0316 0.5118892900855604 0.5118873919682108 -2.7810623563773174e-07 -0.0048118694720830635 -0.031700000000000006 0.5119262966871791 0.5119244020183075 -2.8575406861575114e-07 -0.0048270253243511505 -0.0318 0.5119633000107682 0.5119614089107911 -2.933776054314663e-07 -0.004842180954389359 -0.031900000000000005 0.5120003000554905 0.5119984126445024 -3.0097589522048995e-07 -0.0048573363615030994 -0.032 0.5120372968205169 0.5120354132182746 -3.085479891862253e-07 -0.0048724915449978165 -0.032100000000000004 0.5120742903050265 0.5120724106309344 -3.160929406414992e-07 -0.004887646504179004 -0.0322 0.5121112805082055 0.5121094048813009 -3.236098051057068e-07 -0.004902801238352194 -0.0323 0.5121482674292488 0.512146395968186 -3.3109764055461177e-07 -0.004917955746822954 -0.0324 0.5121852510673581 0.5121833838903946 -3.385555073509572e-07 -0.004933110028896895 -0.0325 0.5122222314217437 0.5122203686467246 -3.4598246859141035e-07 -0.004948264083879677 -0.032600000000000004 0.5122592084916235 0.5122573502359666 -3.533775899400293e-07 -0.004963417911077 -0.0327 0.5122961822762229 0.5122943286569042 -3.6073994000296317e-07 -0.0049785715097945965 -0.0328 0.5123331527747753 0.5123313039083135 -3.680685903006964e-07 -0.004993724879338253 -0.0329 0.5123701199865216 0.5123682759889643 -3.7536261535131565e-07 -0.005008878019013787 -0.033 0.5124070839107105 0.512405244897619 -3.826210930313323e-07 -0.00502403092812708 -0.033100000000000004 0.5124440445465985 0.5124422106330327 -3.8984310446465997e-07 -0.005039183605984024 -0.0332 0.5124810018934496 0.5124791731939543 -3.9702773418914816e-07 -0.005054336051890578 -0.0333 0.5125179559505355 0.5125161325791248 -4.0417407037862674e-07 -0.005069488265152739 -0.0334 0.5125549067171353 0.5125530887872786 -4.112812045931058e-07 -0.00508464024507653 -0.0335 0.5125918541925363 0.512590041817143 -4.1834823247266506e-07 -0.005099791990968038 -0.033600000000000005 0.5126287983760324 0.5126269916674392 -4.253742534876537e-07 -0.005114943502133391 -0.0337 0.5126657392669259 0.5126639383368803 -4.3235837104971253e-07 -0.005130094777878742 -0.033800000000000004 0.5127026768645262 0.5127008818241736 -4.3929969265055213e-07 -0.005145245817510306 -0.0339 0.5127396111681503 0.512737822128019 -4.461973301117528e-07 -0.005160396620334332 -0.034 0.5127765421771223 0.5127747592471099 -4.530503996402757e-07 -0.005175547185657123 -0.0341 0.5128134698907745 0.5128116931801328 -4.598580218562187e-07 -0.005190697512785009 -0.0342 0.5128503943084458 0.5128486239257672 -4.6661932204261625e-07 -0.00520584760102438 -0.034300000000000004 0.5128873154294828 0.5128855514826864 -4.7333342997890604e-07 -0.005220997449681653 -0.0344 0.5129242332532395 0.5129224758495569 -4.799994806348185e-07 -0.005236147058063307 -0.0345 0.5129611477790772 0.5129593970250383 -4.866166135042427e-07 -0.005251296425475858 -0.0346 0.5129980590063641 0.512996315007784 -4.931839732713605e-07 -0.0052664455512258625 -0.0347 0.5130349669344761 0.5130332297964404 -4.997007097273798e-07 -0.00528159443461993 -0.034800000000000005 0.5130718715627962 0.5130701413896478 -5.061659780758454e-07 -0.005296743074964705 -0.0349 0.5131087728907139 0.5131070497860398 -5.125789387383506e-07 -0.0053118914715668715 -0.035 0.5131456709176269 0.5131439549842436 -5.189387578541371e-07 -0.005327039623733182 -0.0351 0.5131825656429391 0.5131808569828797 -5.252446068082506e-07 -0.005342187530770418 -0.0352 0.5132194570660615 0.5132177557805628 -5.314956627311407e-07 -0.005357335191985383 -0.035300000000000005 0.5132563451864128 0.5132546513759009 -5.376911089149949e-07 -0.005372482606684984 -0.0354 0.5132932300034181 0.5132915437674955 -5.438301342863827e-07 -0.005387629774176114 -0.0355 0.5133301115165092 0.5133284329539426 -5.499119336560554e-07 -0.005402776693765755 -0.0356 0.5133669897251253 0.5133653189338313 -5.559357083850802e-07 -0.005417923364760907 -0.0357 0.5134038646287121 0.5134022017057447 -5.619006658852399e-07 -0.0054330697864686285 -0.035800000000000005 0.5134407362267221 0.5134390812682599 -5.678060196745438e-07 -0.005448215958196012 -0.0359 0.5134776045186147 0.5134759576199481 -5.73650989960095e-07 -0.005463361879250218 -0.036 0.5135144695038557 0.5135128307593739 -5.794348037491126e-07 -0.0054785075489384195 -0.0361 0.513551331181918 0.5135497006850968 -5.851566940717756e-07 -0.0054936529665678665 -0.0362 0.5135881895522804 0.5135865673956695 -5.908159012579794e-07 -0.005508798131445853 -0.036300000000000006 0.5136250446144288 0.5136234308896396 -5.964116721601798e-07 -0.005523943042879698 -0.0364 0.5136618963678555 0.5136602911655479 -6.01943260902793e-07 -0.005539087700176793 -0.0365 0.5136987448120591 0.5136971482219305 -6.074099285213741e-07 -0.005554232102644552 -0.0366 0.5137355899465446 0.5137340020573172 -6.128109430458828e-07 -0.005569376249590446 -0.0367 0.5137724317708233 0.5137708526702323 -6.181455800557956e-07 -0.005584520140322003 -0.036800000000000006 0.5138092702844133 0.5138077000591944 -6.234131222915273e-07 -0.005599663774146785 -0.036899999999999995 0.5138461054868378 0.5138445442227166 -6.28612860154032e-07 -0.005614807150372408 -0.037 0.5138829373776272 0.5138813851593065 -6.337440914827575e-07 -0.005629950268306522 -0.0371 0.5139197659563178 0.5139182228674661 -6.388061218887131e-07 -0.005645093127256845 -0.037200000000000004 0.5139565912224514 0.5139550573456926 -6.437982644769136e-07 -0.005660235726531121 -0.03730000000000001 0.5139934131755763 0.5139918885924766 -6.487198404570016e-07 -0.005675378065437159 -0.037399999999999996 0.5140302318152471 0.5140287166063047 -6.535701786436476e-07 -0.005690520143282807 -0.0375 0.5140670471410234 0.5140655413856579 -6.58348616233706e-07 -0.005705661959375974 -0.0376 0.514103859152471 0.514102362929012 -6.630544986396814e-07 -0.005720803513024614 -0.037700000000000004 0.5141406678491619 0.5141391812348377 -6.676871788791061e-07 -0.005735944803536702 -0.03780000000000001 0.5141774732306732 0.5141759963016006 -6.722460189623192e-07 -0.005751085830220288 -0.037899999999999996 0.5142142752965879 0.5142128081277614 -6.767303890042875e-07 -0.005766226592383467 -0.038 0.5142510740464945 0.5142496167117758 -6.811396672801173e-07 -0.005781367089334361 -0.0381 0.5142878694799873 0.5142864220520951 -6.854732413907882e-07 -0.0057965073203812 -0.038200000000000005 0.5143246615966652 0.5143232241471647 -6.897305069863968e-07 -0.0058116472848321835 -0.03830000000000001 0.5143614503961337 0.5143600229954269 -6.939108686543349e-07 -0.005826786981995614 -0.038400000000000004 0.5143982358780027 0.5143968185953178 -6.980137399192898e-07 -0.005841926411179849 -0.0385 0.5144350180418877 0.5144336109452702 -7.020385427436437e-07 -0.0058570655716932265 -0.0386 0.5144717968874094 0.5144704000437115 -7.059847088042304e-07 -0.005872204462844238 -0.038700000000000005 0.5145085724141933 0.5145071858890653 -7.098516781045561e-07 -0.005887343083941333 -0.0388 0.5145453446218702 0.51454396847975 -7.136389002515564e-07 -0.005902481434293023 -0.038900000000000004 0.5145821135100762 0.5145807478141806 -7.173458343445738e-07 -0.005917619513207928 -0.039 0.5146188790784518 0.5146175238907676 -7.209719482537125e-07 -0.005932757319994714 -0.0391 0.5146556413266427 0.5146542967079168 -7.245167193414837e-07 -0.005947894853962005 -0.039200000000000006 0.5146924002542986 0.5146910662640305 -7.279796347958722e-07 -0.005963032114418543 -0.0393 0.5147291558610751 0.5147278325575068 -7.313601909642031e-07 -0.005978169100673109 -0.039400000000000004 0.5147659081466315 0.5147645955867397 -7.346578938527415e-07 -0.005993305812034545 -0.0395 0.514802657110632 0.5148013553501195 -7.378722596262932e-07 -0.006008442247811741 -0.0396 0.5148394027527452 0.5148381118460328 -7.410028132759372e-07 -0.006023578407313624 -0.039700000000000006 0.5148761450726442 0.5148748650728623 -7.44049090672938e-07 -0.00603871428984919 -0.0398 0.5149128840700063 0.5149116150289872 -7.470106369589224e-07 -0.006053849894727487 -0.039900000000000005 0.5149496197445131 0.514948361712783 -7.498870073230357e-07 -0.006068985221257556 -0.04 0.5149863520958504 0.5149851051226219 -7.526777671684748e-07 -0.006084120268748611 -0.040100000000000004 0.515023081123708 0.5150218452568718 -7.553824919459551e-07 -0.006099255036509783 -0.0402 0.5150598068277796 0.5150585821138988 -7.58000767042688e-07 -0.006114389523850339 -0.0403 0.5150965292077633 0.5150953156920642 -7.605321885040262e-07 -0.006129523730079534 -0.040400000000000005 0.5151332482633607 0.5151320459897275 -7.629763624783514e-07 -0.006144657654506786 -0.0405 0.5151699639942774 0.5151687730052438 -7.653329051615643e-07 -0.0061597912964414196 -0.040600000000000004 0.5152066764002224 0.515205496736966 -7.676014439073064e-07 -0.0061749246551929095 -0.0407 0.5152433854809085 0.515242217183244 -7.697816156726489e-07 -0.006190057730070759 -0.0408 0.5152800912360521 0.5152789343424244 -7.71873068572404e-07 -0.006205190520384519 -0.040900000000000006 0.5153167936653731 0.5153156482128515 -7.738754611019694e-07 -0.006220323025443786 -0.041 0.5153534927685945 0.5153523587928666 -7.757884624148836e-07 -0.006235455244558247 -0.041100000000000005 0.5153901885454429 0.5153890660808083 -7.776117523228265e-07 -0.006250587177037548 -0.0412 0.515426880995648 0.5154257700750129 -7.793450215176634e-07 -0.006265718822191491 -0.0413 0.5154635701189425 0.5154624707738142 -7.809879712383783e-07 -0.006280850179329889 -0.041400000000000006 0.5155002559150624 0.5154991681755436 -7.82540313992719e-07 -0.006295981247762589 -0.0415 0.5155369383837465 0.5155358622785304 -7.840017729465742e-07 -0.006311112026799542 -0.0416 0.5155736175247366 0.5155725530811015 -7.853720823125521e-07 -0.006326242515750713 -0.0417 0.5156102933377773 0.5156092405815812 -7.86650987183446e-07 -0.006341372713926136 -0.041800000000000004 0.5156469658226155 0.5156459247782926 -7.878382435877462e-07 -0.006356502620635873 -0.04190000000000001 0.5156836349790015 0.5156826056695567 -7.889336189337293e-07 -0.006371632235190056 -0.042 0.5157203008066874 0.5157192832536921 -7.899368914543459e-07 -0.006386761556898896 -0.0421 0.5157569633054283 0.5157559575290163 -7.908478509843775e-07 -0.006401890585072623 -0.0422 0.5157936224749814 0.5157926284938446 -7.916662984608358e-07 -0.006417019319021561 -0.042300000000000004 0.5158302783151059 0.5158292961464908 -7.923920458119404e-07 -0.0064321477580559895 -0.04240000000000001 0.5158669308255635 0.5158659604852674 -7.930249162901859e-07 -0.006447275901486338 -0.0425 0.5159035800061184 0.5159026215084854 -7.935647447498972e-07 -0.006462403748623075 -0.0426 0.5159402258565362 0.5159392792144546 -7.940113769255852e-07 -0.006477531298776734 -0.0427 0.5159768683765845 0.5159759336014832 -7.943646705976803e-07 -0.006492658551257857 -0.042800000000000005 0.516013507566033 0.5160125846678785 -7.946244943712877e-07 -0.0065077855053770175 -0.04290000000000001 0.5160501434246532 0.5160492324119468 -7.947907287308986e-07 -0.006522912160444977 -0.043 0.5160867759522177 0.5160858768319931 -7.948632653742571e-07 -0.006538038515772432 -0.0431 0.5161234051485015 0.5161225179263218 -7.948420075454266e-07 -0.006553164570670178 -0.0432 0.5161600310132801 0.5161591556932363 -7.947268702013233e-07 -0.006568290324449006 -0.043300000000000005 0.5161966535463312 0.5161957901310394 -7.945177797341607e-07 -0.0065834157764198655 -0.04340000000000001 0.5162332727474335 0.5162324212380336 -7.942146739159384e-07 -0.0065985409258936594 -0.0435 0.5162698886163668 0.5162690490125204 -7.938175026755978e-07 -0.0066136657721814485 -0.0436 0.5163065011529124 0.516305673452801 -7.933262270443109e-07 -0.006628790314594252 -0.0437 0.5163431103568523 0.5163422945571763 -7.927408195995689e-07 -0.006643914552443203 -0.043800000000000006 0.5163797162279694 0.5163789123239471 -7.920612651868275e-07 -0.00665903848503947 -0.04390000000000001 0.5164163187660473 0.5164155267514137 -7.912875601423508e-07 -0.006674162111694266 -0.044 0.516452917970871 0.5164521378378766 -7.904197121821888e-07 -0.006689285431718911 -0.0441 0.5164895138422254 0.5164887455816364 -7.894577411238224e-07 -0.00670440844442472 -0.0442 0.5165261063798966 0.5165253499809936 -7.884016778314518e-07 -0.00671953114912311 -0.044300000000000006 0.5165626955836706 0.5165619510342493 -7.872515657703083e-07 -0.006734653545125541 -0.04440000000000001 0.5165992814533344 0.5165985487397041 -7.860074595633648e-07 -0.006749775631743483 -0.0445 0.5166358639886748 0.5166351430956598 -7.846694257684916e-07 -0.006764897408288573 -0.0446 0.5166724431894787 0.5166717341004183 -7.832375428229454e-07 -0.006780018874072364 -0.044700000000000004 0.5167090190555337 0.5167083217522822 -7.817119005437689e-07 -0.0067951400284065825 -0.044800000000000006 0.5167455915866268 0.5167449060495548 -7.800926009049469e-07 -0.006810260870602925 -0.0449 0.5167821607825454 0.5167814869905403 -7.783797574267837e-07 -0.006825381399973263 -0.045 0.5168187266430759 0.5168180645735432 -7.765734951203918e-07 -0.006840501615829376 -0.0451 0.5168552891680058 0.5168546387968698 -7.746739514313816e-07 -0.006855621517483229 -0.045200000000000004 0.5168918483571212 0.5168912096588267 -7.726812751851497e-07 -0.006870741104246742 -0.04530000000000001 0.5169284042102076 0.5169277771577221 -7.705956265313674e-07 -0.006885860375431929 -0.0454 0.5169649567270509 0.5169643412918653 -7.684171782207372e-07 -0.006900979330350937 -0.0455 0.5170015059074354 0.517000902059567 -7.661461141617032e-07 -0.006916097968315893 -0.0456 0.5170380517511453 0.5170374594591389 -7.637826304196516e-07 -0.006931216288638959 -0.045700000000000005 0.5170745942579638 0.5170740134888949 -7.613269342177098e-07 -0.006946334290632423 -0.04580000000000001 0.5171111334276728 0.5171105641471502 -7.587792446583919e-07 -0.006961451973608585 -0.0459 0.5171476692600538 0.5171471114322215 -7.561397927791091e-07 -0.0069765693368798514 -0.046 0.5171842017548869 0.5171836553424276 -7.534088211080814e-07 -0.006991686379758628 -0.0461 0.5172207309119508 0.5172201958760891 -7.505865842194481e-07 -0.00700680310155743 -0.046200000000000005 0.517257256731023 0.5172567330315285 -7.476733476230457e-07 -0.007021919501588748 -0.0463 0.5172937792118799 0.5172932668070707 -7.446693889856526e-07 -0.007037035579165224 -0.046400000000000004 0.5173302983542962 0.5173297972010422 -7.415749973538333e-07 -0.007052151333599561 -0.0465 0.517366814158045 0.5173663242117723 -7.383904734314939e-07 -0.007067266764204472 -0.0466 0.5174033266228979 0.5174028478375925 -7.351161294688602e-07 -0.007082381870292743 -0.046700000000000005 0.5174398357486245 0.5174393680768363 -7.317522890959438e-07 -0.00709749665117721 -0.0468 0.5174763415349927 0.5174758849278405 -7.282992879331651e-07 -0.007112611106170791 -0.046900000000000004 0.5175128439817686 0.5175123983889441 -7.247574723701078e-07 -0.007127725234586446 -0.047 0.5175493430887156 0.5175489084584892 -7.211272008977865e-07 -0.00714283903573722 -0.0471 0.5175858388555958 0.51758541513482 -7.174088429429126e-07 -0.007157952508936156 -0.047200000000000006 0.5176223312821686 0.5176219184162842 -7.136027797005617e-07 -0.007173065653496441 -0.0473 0.5176588203681916 0.5176584183012324 -7.097094034125284e-07 -0.007188178468731277 -0.047400000000000005 0.517695306113419 0.5176949147880181 -7.057291176448821e-07 -0.0072032909539539065 -0.0475 0.5177317885176034 0.5177314078749983 -7.016623374545006e-07 -0.007218403108477656 -0.0476 0.5177682675804948 0.517767897560533 -6.975094888894695e-07 -0.007233514931615942 -0.047700000000000006 0.51780474330184 0.5178043838429858 -6.932710095997052e-07 -0.007248626422682192 -0.0478 0.5178412156813834 0.5178408667207236 -6.889473478932651e-07 -0.0072637375809899325 -0.047900000000000005 0.5178776847188664 0.5178773461921169 -6.845389632914589e-07 -0.0072788484058527066 -0.048 0.5179141504140273 0.5179138222555397 -6.800463267508938e-07 -0.00729395889658418 -0.048100000000000004 0.5179506127666019 0.5179502949093701 -6.75469919941829e-07 -0.007309069052498019 -0.0482 0.5179870717763224 0.5179867641519894 -6.708102354147094e-07 -0.007324178872907994 -0.0483 0.5180235274429181 0.5180232299817836 -6.660677768777212e-07 -0.007339288357127888 -0.048400000000000006 0.5180599797661145 0.5180596923971422 -6.612430590302587e-07 -0.007354397504471644 -0.0485 0.5180964287456344 0.5180961513964587 -6.563366068967902e-07 -0.007369506314253139 -0.048600000000000004 0.5181328743811965 0.5181326069781311 -6.513489565485031e-07 -0.007384614785786398 -0.0487 0.5181693166725163 0.5181690591405613 -6.462806549367706e-07 -0.007399722918385476 -0.0488 0.5182057556193058 0.5182055078821561 -6.411322595045732e-07 -0.0074148307113645175 -0.048900000000000006 0.5182421912212727 0.518241953201326 -6.359043384085439e-07 -0.007429938164037692 -0.049 0.5182786234781211 0.5182783950964868 -6.305974701859007e-07 -0.0074450452757192425 -0.049100000000000005 0.5183150523895516 0.5183148335660581 -6.252122439209806e-07 -0.007460152045723501 -0.0492 0.51835147795526 0.5183512686084649 -6.19749259189728e-07 -0.00747525847336481 -0.049300000000000004 0.518387900174939 0.5183877002221364 -6.142091257821392e-07 -0.007490364557957619 -0.049400000000000006 0.5184243190482765 0.5184241284055072 -6.085924638132845e-07 -0.007505470298816436 -0.0495 0.5184607345749561 0.5184605531570166 -6.028999038343308e-07 -0.00752057569525581 -0.0496 0.5184971467546575 0.5184969744751088 -5.971320861108964e-07 -0.007535680746590379 -0.0497 0.5185335555870555 0.5185333923582333 -5.912896615667407e-07 -0.007550785452134829 -0.049800000000000004 0.5185699610718209 0.5185698068048447 -5.853732908955855e-07 -0.007565889811203905 -0.04990000000000001 0.5186063632086195 0.518606217813403 -5.793836445611156e-07 -0.007580993823112437 -0.05 0.5186427619971127 0.5186426253823735 -5.733214030745337e-07 -0.007596097487175288 -0.0501 0.5186791574369568 0.5186790295102267 -5.671872569390501e-07 -0.00761120080270741 -0.0502 0.518715549527804 0.518715430195439 -5.60981905817215e-07 -0.007626303769023799 -0.050300000000000004 0.5187519382693008 0.5187518274364924 -5.547060596411413e-07 -0.0076414063854395396 -0.05040000000000001 0.5187883236610888 0.5187882212318742 -5.483604377798379e-07 -0.007656508651269745 -0.0505 0.5188247057028053 0.5188246115800778 -5.419457686506313e-07 -0.007671610565829632 -0.0506 0.5188610843940817 0.5188609984796022 -5.354627906350995e-07 -0.007686712128434459 -0.0507 0.5188974597345446 0.5188973819289525 -5.289122512464051e-07 -0.007701813338399546 -0.050800000000000005 0.5189338317238148 0.51893376192664 -5.222949072125616e-07 -0.007716914195040301 -0.05090000000000001 0.5189702003615084 0.5189701384711815 -5.156115243099002e-07 -0.007732014697672163 -0.051 0.5190065656472356 0.5190065115611003 -5.088628776128701e-07 -0.007747114845610664 -0.0511 0.519042927580601 0.519042881194926 -5.020497510777044e-07 -0.007762214638171378 -0.0512 0.519079286161204 0.5190792473711944 -4.951729375701763e-07 -0.007777314074669964 -0.051300000000000005 0.5191156413886381 0.5191156100884478 -4.882332389211097e-07 -0.007792413154422137 -0.05140000000000001 0.519151993262491 0.5191519693452346 -4.812314654822902e-07 -0.0078075118767436755 -0.0515 0.5191883417823449 0.5191883251401098 -4.7416843632075434e-07 -0.007822610240950425 -0.0516 0.5192246869477756 0.5192246774716354 -4.67044978968989e-07 -0.007837708246358306 -0.0517 0.5192610287583532 0.5192610263383796 -4.5986192945268733e-07 -0.007852805892283274 -0.051800000000000006 0.5192973672136421 0.5192973717389175 -4.526201321519707e-07 -0.007867903178041397 -0.05190000000000001 0.5193337023132 0.5193337136718315 -4.4532043985689995e-07 -0.007883000102948774 -0.052 0.519370034056579 0.5193700521357096 -4.379637132123637e-07 -0.007898096666321587 -0.0521 0.5194063624433245 0.5194063871291482 -4.305508210511455e-07 -0.007913192867476071 -0.0522 0.5194426874729756 0.5194427186507495 -4.230826401996346e-07 -0.007928288705728535 -0.052300000000000006 0.5194790091450654 0.5194790466991239 -4.1556005525578144e-07 -0.007943384180395347 -0.05240000000000001 0.5195153274591203 0.5195153712728879 -4.0798395867236437e-07 -0.007958479290792948 -0.0525 0.5195516424146606 0.5195516923706659 -4.003552504794339e-07 -0.007973574036237868 -0.0526 0.5195879540111991 0.5195880099910892 -3.926748382843126e-07 -0.007988668416046655 -0.052700000000000004 0.519624262248243 0.5196243241327968 -3.849436370217951e-07 -0.008003762429535953 -0.05280000000000001 0.5196605671252923 0.5196606347944347 -3.7716256912068147e-07 -0.008018856076022478 -0.0529 0.5196968686418402 0.5196969419746564 -3.693325641984657e-07 -0.008033949354823003 -0.053 0.5197331667973734 0.5197332456721234 -3.6145455883929145e-07 -0.008049042265254368 -0.0531 0.5197694615913715 0.5197695458855043 -3.53529496704974e-07 -0.008064134806633483 -0.053200000000000004 0.519805753023307 0.5198058426134751 -3.4555832845173384e-07 -0.008079226978277319 -0.05330000000000001 0.5198420410926458 0.5198421358547204 -3.375420113416183e-07 -0.008094318779502934 -0.0534 0.5198783257988465 0.5198784256079318 -3.294815095478132e-07 -0.008109410209627433 -0.0535 0.5199146071413606 0.5199147118718092 -3.213777934607531e-07 -0.008124501267967993 -0.0536 0.5199508851196324 0.5199509946450596 -3.1323184024323325e-07 -0.008139591953841853 -0.053700000000000005 0.5199871597330991 0.5199872739263991 -3.050446330810086e-07 -0.008154682266566347 -0.05380000000000001 0.5200234309811903 0.5200235497145508 -2.968171616685167e-07 -0.008169772205458848 -0.0539 0.5200596988633291 0.5200598220082463 -2.8855042147335475e-07 -0.008184861769836812 -0.054 0.5200959633789303 0.520096090806225 -2.8024541408322445e-07 -0.008199950959017757 -0.0541 0.5201322245274016 0.5201323561072349 -2.7190314702552065e-07 -0.00821503977231928 -0.054200000000000005 0.5201684823081435 0.5201686179100317 -2.6352463335099774e-07 -0.008230128209059034 -0.0543 0.5202047367205488 0.5202048762133795 -2.551108919113254e-07 -0.008245216268554746 -0.054400000000000004 0.5202409877640022 0.5202411310160509 -2.466629468456105e-07 -0.00826030395012421 -0.0545 0.5202772354378814 0.5202773823168267 -2.3818182787183062e-07 -0.0082753912530853 -0.0546 0.5203134797415562 0.5203136301144958 -2.2966856973172245e-07 -0.008290478176755937 -0.054700000000000006 0.5203497206743887 0.5203498744078562 -2.2112421237119317e-07 -0.008305564720454134 -0.0548 0.5203859582357332 0.5203861151957135 -2.1254980074603136e-07 -0.00832065088349796 -0.054900000000000004 0.5204221924249361 0.5204223524768827 -2.039463846831291e-07 -0.008335736665205557 -0.055 0.5204584232413366 0.5204585862501868 -1.953150186306818e-07 -0.008350822064895139 -0.0551 0.5204946506842649 0.5204948165144576 -1.866567616998216e-07 -0.008365907081884989 -0.055200000000000006 0.520530874753044 0.5205310432685355 -1.7797267753971724e-07 -0.008380991715493454 -0.0553 0.5205670954469888 0.5205672665112697 -1.6926383403226275e-07 -0.008396075965038954 -0.055400000000000005 0.5206033127654061 0.5206034862415182 -1.6053130327819964e-07 -0.008411159829839993 -0.0555 0.5206395267075947 0.5206397024581471 -1.5177616158323914e-07 -0.008426243309215124 -0.055600000000000004 0.5206757372728454 0.5206759151600321 -1.4299948906948412e-07 -0.00844132640248298 -0.0557 0.5207119444604407 0.5207121243460575 -1.3420236975175692e-07 -0.008456409108962266 -0.0558 0.5207481482696548 0.5207483300151163 -1.25385891301677e-07 -0.008471491427971755 -0.055900000000000005 0.520784348699754 0.5207845321661105 -1.1655114495745522e-07 -0.00848657335883029 -0.056 0.5208205457499963 0.5208207307979513 -1.0769922533654386e-07 -0.00850165490085679 -0.056100000000000004 0.5208567394196313 0.5208569259095586 -9.883123038012531e-08 -0.00851673605337024 -0.0562 0.5208929297079005 0.520893117499861 -8.994826112412868e-08 -0.008531816815689692 -0.0563 0.5209291166140372 0.5209293055677969 -8.105142169229085e-08 -0.008546897187134283 -0.056400000000000006 0.5209653001372658 0.5209654901123133 -7.214181904288686e-08 -0.008561977167023211 -0.0565 0.5210014802768028 0.5210016711323662 -6.322056285076871e-08 -0.008577056754675743 -0.056600000000000004 0.5210376570318562 0.5210378486269208 -5.4288765410220874e-08 -0.008592135949411226 -0.0567 0.5210738304016255 0.5210740225949518 -4.5347541461487895e-08 -0.008607214750549074 -0.0568 0.521110000385302 0.5211101930354425 -3.639800807281324e-08 -0.00862229315740878 -0.056900000000000006 0.521146166982068 0.5211463599473857 -2.744128451206973e-08 -0.008637371169309894 -0.057 0.5211823301910976 0.5211825233297837 -1.8478492070685137e-08 -0.00865244878557205 -0.0571 0.5212184900115565 0.5212186831816472 -9.510753944813599e-09 -0.00866752600551495 -0.0572 0.521254646442602 0.521254839501997 -5.391950961240732e-10 -0.008682602828458374 -0.057300000000000004 0.5212907994833821 0.5212909922898626 8.435057891748032e-09 -0.008697679253722166 -0.05740000000000001 0.521326949133037 0.5213271415442834 1.7410876957182908e-08 -0.008712755280626249 -0.0575 0.5213630953906981 0.5213632872643075 2.638713269415005e-08 -0.008727830908490615 -0.0576 0.5213992382554877 0.5213994294489928 3.536269451570595e-08 -0.008742906136635328 -0.0577 0.5214353777265203 0.5214355680974058 4.433643076284799e-08 -0.00875798096438053 -0.057800000000000004 0.5214715138029011 0.5214717032086235 5.330720887278262e-08 -0.008773055391046431 -0.05790000000000001 0.521507646483727 0.521507834781731 6.227389552290741e-08 -0.008788129415953317 -0.058 0.5215437757680862 0.5215439628158237 7.12353567383639e-08 -0.008803203038421546 -0.0581 0.5215799016550581 0.5215800873100063 8.019045811408221e-08 -0.008818276257771549 -0.0582 0.5216160241437134 0.5216162082633921 8.913806484600606e-08 -0.008833349073323834 -0.058300000000000005 0.5216521432331144 0.5216523256751051 9.807704198783185e-08 -0.008848421484398981 -0.05840000000000001 0.5216882589223145 0.5216884395442773 1.0700625450998924e-07 -0.008863493490317642 -0.0585 0.5217243712103582 0.5217245498700515 1.1592456745229685e-07 -0.008878565090400543 -0.0586 0.5217604800962818 0.5217606566515784 1.248308461460068e-07 -0.008893636283968482 -0.0587 0.5217965855791126 0.5217967598880197 1.3372395631094935e-07 -0.008908707070342338 -0.058800000000000005 0.5218326876578692 0.5218328595785453 1.4260276415961615e-07 -0.008923777448843062 -0.05890000000000001 0.5218687863315613 0.521868955722335 1.5146613657757158e-07 -0.008938847418791676 -0.059 0.5219048815991905 0.5219050483185782 1.6031294133855845e-07 -0.008953916979509277 -0.0591 0.5219409734597491 0.5219411373664734 1.6914204711837577e-07 -0.008968986130317038 -0.0592 0.5219770619122208 0.5219772228652289 1.7795232366835112e-07 -0.008984054870536213 -0.059300000000000005 0.5220131469555809 0.5220133048140618 1.8674264204432411e-07 -0.008999123199488111 -0.05940000000000001 0.5220492285887957 0.5220493832121993 1.9551187466215758e-07 -0.009014191116494144 -0.0595 0.522085306810823 0.5220854580588774 2.0425889553365995e-07 -0.009029258620875778 -0.0596 0.522121381620612 0.5221215293533419 2.1298258033597417e-07 -0.00904432571195456 -0.0597 0.5221574530171027 0.5221575970948478 2.21681806591989e-07 -0.009059392389052115 -0.059800000000000006 0.5221935209992273 0.5221936612826596 2.3035545379523903e-07 -0.009074458651490145 -0.05990000000000001 0.5222295855659087 0.5222297219160511 2.3900240350704927e-07 -0.009089524498590419 -0.06 0.5222656467160613 0.5222657789943054 2.47621539689602e-07 -0.00910458992967479 -0.0601 0.522301704448591 0.5223018325167151 2.562117485810367e-07 -0.009119654944065182 -0.060200000000000004 0.5223377587623951 0.5223378824825822 2.6477191912566145e-07 -0.009134719541083606 -0.060300000000000006 0.522373809656362 0.5223739288912174 2.7330094283517514e-07 -0.009149783720052125 -0.0604 0.522409857129372 0.5224099717419413 2.8179771414948984e-07 -0.009164847480292901 -0.0605 0.5224459011802967 0.5224460110340836 2.9026113043673085e-07 -0.009179910821128163 -0.0606 0.5224819418079988 0.5224820467669835 2.9869009227079246e-07 -0.009194973741880217 -0.060700000000000004 0.522517979011333 0.5225180789399893 3.0708350340358237e-07 -0.009210036241871455 -0.06080000000000001 0.522554012789145 0.5225541075524579 3.1544027126462204e-07 -0.009225098320424329 -0.0609 0.5225900431402728 0.5225901326037563 3.237593065030797e-07 -0.009240159976861381 -0.061 0.522626070063545 0.5226261540932601 3.3203952373717094e-07 -0.009255221210505218 -0.0611 0.5226620935577821 0.5226621720203544 3.40279841332114e-07 -0.00927028202067854 -0.061200000000000004 0.5226981136217971 0.5226981863844331 3.4847918153890767e-07 -0.009285342406704108 -0.06130000000000001 0.5227341302543932 0.5227341971848996 3.5663647107719854e-07 -0.009300402367904772 -0.0614 0.5227701434543659 0.5227702044211656 3.647506406356804e-07 -0.009315461903603451 -0.0615 0.5228061532205027 0.5228062080926529 3.728206255104727e-07 -0.009330521013123146 -0.0616 0.5228421595515825 0.5228422081987913 3.808453653830757e-07 -0.009345579695786936 -0.061700000000000005 0.5228781624463757 0.5228782047390206 3.8882380481997103e-07 -0.009360637950917978 -0.06180000000000001 0.5229141619036454 0.5229141977127885 3.9675489310608825e-07 -0.009375695777839511 -0.061900000000000004 0.5229501579221452 0.5229501871195522 4.046375845778716e-07 -0.009390753175874844 -0.062 0.5229861505006217 0.5229861729587777 4.1247083859552447e-07 -0.009405810144347361 -0.0621 0.5230221396378127 0.5230221552299398 4.202536198483209e-07 -0.009420866682580534 -0.062200000000000005 0.5230581253324484 0.5230581339325218 4.2798489849338317e-07 -0.00943592278989791 -0.0623 0.5230941075832505 0.5230941090660162 4.3566365010017094e-07 -0.009450978465623107 -0.062400000000000004 0.523130086388933 0.5231300806299239 4.432888560113035e-07 -0.009466033709079833 -0.0625 0.5231660617482021 0.5231660486237548 4.508595032037821e-07 -0.009481088519591877 -0.0626 0.5232020336597557 0.5232020130470272 4.5837458489961236e-07 -0.009496142896483093 -0.0627 0.5232380021222842 0.5232379738992681 4.6583310017722646e-07 -0.009511196839077425 -0.06280000000000001 0.5232739671344698 0.5232739311800128 4.7323405438781663e-07 -0.009526250346698887 -0.06290000000000001 0.5233099286949873 0.5233098848888054 4.805764592108464e-07 -0.009541303418671597 -0.063 0.5233458868025034 0.5233458350251985 4.878593329038505e-07 -0.00955635605431971 -0.0631 0.5233818414556775 0.5233817815887528 4.950817002746799e-07 -0.009571408252967505 -0.0632 0.523417792653161 0.5234177245790375 5.022425928202789e-07 -0.009586460013939289 -0.06330000000000001 0.5234537403935984 0.5234536639956301 5.093410489487304e-07 -0.009601511336559504 -0.06340000000000001 0.5234896846756253 0.5234895998381165 5.163761142845669e-07 -0.009616562220152631 -0.0635 0.5235256254978713 0.5235255321060905 5.233468413357034e-07 -0.009631612664043242 -0.0636 0.5235615628589578 0.5235614607991547 5.30252289826505e-07 -0.00964666266755602 -0.0637 0.5235974967574992 0.523597385916919 5.370915270863641e-07 -0.009661712230015683 -0.06380000000000001 0.523633427192102 0.5236333074590016 5.438636280774567e-07 -0.009676761350747038 -0.06390000000000001 0.5236693541613662 0.5236692254250288 5.505676750339195e-07 -0.009691810029074996 -0.064 0.523705277663884 0.5237051398146351 5.572027582945172e-07 -0.009706858264324542 -0.0641 0.5237411976982407 0.5237410506274622 5.637679759418202e-07 -0.009721906055820712 -0.06420000000000001 0.5237771142630145 0.5237769578631603 5.702624342462936e-07 -0.009736953402888644 -0.0643 0.5238130273567768 0.523812861521387 5.766852473332307e-07 -0.009752000304853604 -0.0644 0.5238489369780917 0.5238487616018076 5.830355379876639e-07 -0.009767046761040843 -0.0645 0.5238848431255162 0.5238846581040949 5.893124371270098e-07 -0.009782092770775769 -0.0646 0.5239207457976011 0.5239205510279298 5.955150842729129e-07 -0.009797138333383824 -0.06470000000000001 0.5239566449928899 0.523956440373 6.016426275512465e-07 -0.009812183448190582 -0.0648 0.5239925407099196 0.5239923261390014 6.076942239419125e-07 -0.009827228114521658 -0.0649 0.5240284329472208 0.5240282083256365 6.136690391400634e-07 -0.009842272331702756 -0.065 0.5240643217033168 0.5240640869326155 6.19566247916925e-07 -0.009857316099059639 -0.0651 0.5241002069767253 0.5240999619596559 6.25385034147552e-07 -0.009872359415918236 -0.06520000000000001 0.5241360887659569 0.5241358334064823 6.311245911438945e-07 -0.00988740228160443 -0.0653 0.5241719670695163 0.5241717012728263 6.367841210996872e-07 -0.009902444695444313 -0.0654 0.5242078418859015 0.5242075655584264 6.423628358120936e-07 -0.009917486656763987 -0.0655 0.5242437132136046 0.5242434262630286 6.478599570147736e-07 -0.009932528164889648 -0.0656 0.5242795810511113 0.524279283386385 6.532747158782826e-07 -0.009947569219147585 -0.06570000000000001 0.5243154453969012 0.5243151369282553 6.586063529545605e-07 -0.009962609818864149 -0.0658 0.5243513062494481 0.5243509868884051 6.63854119287155e-07 -0.009977649963365776 -0.0659 0.52438716360722 0.5243868332666075 6.69017275578554e-07 -0.009992689651979025 -0.066 0.5244230174686789 0.5244226760626418 6.740950928563194e-07 -0.010007728884030509 -0.0661 0.5244588678322809 0.5244585152762935 6.790868521955318e-07 -0.010022767658846927 -0.06620000000000001 0.5244947146964766 0.5244943509073551 6.839918448853233e-07 -0.01003780597575505 -0.0663 0.5245305580597106 0.5245301829556248 6.888093729284783e-07 -0.010052843834081733 -0.0664 0.5245663979204227 0.5245660114209076 6.93538748486322e-07 -0.010067881233153903 -0.0665 0.5246022342770467 0.5246018363030144 6.981792946558762e-07 -0.010082918172298623 -0.0666 0.524638067128011 0.5246376576017624 7.027303450257705e-07 -0.010097954650842995 -0.06670000000000001 0.5246738964717389 0.5246734753169747 7.071912442313533e-07 -0.010112990668114226 -0.0668 0.5247097223066488 0.5247092894484803 7.115613472885585e-07 -0.01012802622343958 -0.0669 0.5247455446311537 0.524745099996114 7.158400210927063e-07 -0.010143061316146436 -0.067 0.5247813634436613 0.5247809069597165 7.200266426421464e-07 -0.010158095945562235 -0.0671 0.5248171787425746 0.5248167103391341 7.241206009256373e-07 -0.010173130111014506 -0.06720000000000001 0.5248529905262919 0.5248525101342187 7.281212960341676e-07 -0.010188163811830887 -0.0673 0.5248887987932066 0.5248883063448277 7.320281387723782e-07 -0.010203197047339036 -0.0674 0.5249246035417073 0.5249240989708241 7.358405523238964e-07 -0.010218229816866787 -0.0675 0.5249604047701784 0.5249598880120758 7.395579709190692e-07 -0.010233262119741971 -0.06760000000000001 0.5249962024769991 0.5249956734684563 7.431798405010959e-07 -0.010248293955292571 -0.0677 0.5250319966605449 0.5250314553398441 7.467056187815402e-07 -0.010263325322846618 -0.0678 0.5250677873191867 0.5250672336261227 7.501347751293075e-07 -0.010278356221732232 -0.0679 0.5251035744512913 0.5251030083271808 7.534667907926895e-07 -0.010293386651277643 -0.068 0.5251393580552209 0.5251387794429117 7.567011594544759e-07 -0.010308416610811123 -0.06810000000000001 0.5251751381293344 0.5251745469732135 7.598373861217311e-07 -0.010323446099661083 -0.0682 0.5252109146719862 0.5252103109179891 7.628749882360175e-07 -0.010338475117155937 -0.0683 0.5252466876815272 0.525246071277146 7.658134956178841e-07 -0.01035350366262431 -0.0684 0.5252824571563043 0.5252818280505962 7.68652449800733e-07 -0.01036853173539481 -0.0685 0.5253182230946606 0.5253175812382558 7.7139140552962e-07 -0.010383559334796134 -0.06860000000000001 0.5253539854949361 0.5253533308400454 7.740299291514319e-07 -0.010398586460157117 -0.0687 0.5253897443554671 0.52538907685589 7.765675997251087e-07 -0.01041361311080663 -0.0688 0.5254254996745866 0.5254248192857184 7.790040090771555e-07 -0.010428639286073717 -0.0689 0.5254612514506243 0.5254605581294637 7.813387613575529e-07 -0.010443664985287421 -0.069 0.5254969996819066 0.5254962933870624 7.83571473428335e-07 -0.010458690207776839 -0.06910000000000001 0.525532744366757 0.5255320250584552 7.857017750856343e-07 -0.010473714952871272 -0.0692 0.525568485503496 0.5255677531435865 7.877293088376369e-07 -0.010488739219900034 -0.0693 0.5256042230904414 0.5256034776424042 7.89653729738049e-07 -0.010503763008192552 -0.0694 0.5256399571259079 0.5256391985548599 7.914747062742755e-07 -0.010518786317078295 -0.0695 0.5256756876082079 0.525674915880908 7.931919195347525e-07 -0.01053380914588688 -0.06960000000000001 0.5257114145356511 0.5257106296205069 7.948050638750814e-07 -0.010548831493948002 -0.0697 0.5257471379065444 0.5257463397736177 7.963138465849617e-07 -0.010563853360591364 -0.0698 0.5257828577191929 0.525782046340205 7.977179879992136e-07 -0.010578874745146866 -0.0699 0.5258185739718991 0.5258177493202361 7.990172220528891e-07 -0.010593895646944435 -0.07 0.525854286662964 0.5258534487136811 8.002112955041163e-07 -0.0106089160653141 -0.07010000000000001 0.5258899957906855 0.5258891445205129 8.012999684892108e-07 -0.010623935999585988 -0.0702 0.5259257013533603 0.5259248367407076 8.022830144116533e-07 -0.01063895544909025 -0.0703 0.525961403349283 0.525960525374243 8.031602203306676e-07 -0.010653974413157213 -0.0704 0.525997101776747 0.5259962104211001 8.039313864061093e-07 -0.010668992891117269 -0.0705 0.5260327966340432 0.526031891881262 8.045963263425548e-07 -0.01068401088230085 -0.07060000000000001 0.526068487919462 0.5260675697547139 8.051548673893016e-07 -0.010699028386038556 -0.0707 0.5261041756312916 0.5261032440414432 8.056068502293456e-07 -0.01071404540166101 -0.0708 0.5261398597678193 0.5261389147414395 8.059521293124483e-07 -0.0107290619284989 -0.0709 0.526175540327331 0.5261745818546939 8.061905725220697e-07 -0.010744077965883093 -0.071 0.5262112173081119 0.5262102453811998 8.063220612863908e-07 -0.010759093513144514 -0.07110000000000001 0.5262468907084459 0.5262459053209521 8.063464908558693e-07 -0.010774108569614095 -0.0712 0.526282560526616 0.5262815616739469 8.062637701367059e-07 -0.010789123134622963 -0.0713 0.526318226760905 0.5263172144401826 8.06073821801867e-07 -0.010804137207502312 -0.0714 0.5263538894095945 0.5263528636196586 8.057765819025065e-07 -0.010819150787583366 -0.0715 0.5263895484709654 0.5263885092123751 8.053720008116549e-07 -0.010834163874197495 -0.07160000000000001 0.5264252039432993 0.5264241512183342 8.048600422805308e-07 -0.010849176466676158 -0.0717 0.526460855824876 0.5264597896375385 8.042406842156957e-07 -0.010864188564350875 -0.0718 0.5264965041139764 0.5264954244699919 8.035139178463879e-07 -0.010879200166553261 -0.0719 0.5265321488088807 0.5265310557156987 8.026797486682113e-07 -0.010894211272615063 -0.072 0.5265677899078692 0.5265666833746644 8.017381958325132e-07 -0.010909221881868065 -0.07210000000000001 0.5266034274092224 0.5266023074468948 8.00689292257406e-07 -0.010924231993644173 -0.0722 0.5266390613112211 0.5266379279323962 7.995330849608351e-07 -0.010939241607275342 -0.0723 0.5266746916121463 0.5266735448311753 7.982696348940443e-07 -0.010954250722093679 -0.0724 0.5267103183102795 0.5267091581432394 7.968990165529988e-07 -0.010969259337431326 -0.0725 0.5267459414039029 0.5267447678685951 7.954213185334957e-07 -0.010984267452620511 -0.07260000000000001 0.5267815608912993 0.5267803740072501 7.93836643531165e-07 -0.010999275066993615 -0.0727 0.5268171767707529 0.5268159765592112 7.921451080084019e-07 -0.01101428217988309 -0.0728 0.5268527890405478 0.5268515755244857 7.903468419168114e-07 -0.011029288790621445 -0.0729 0.5268883976989698 0.5268871709030798 7.88441989696409e-07 -0.011044294898541297 -0.073 0.5269240027443057 0.5269227626949999 7.864307094984646e-07 -0.01105930050297534 -0.07310000000000001 0.5269596041748437 0.5269583509002519 7.843131731299913e-07 -0.011074305603256408 -0.0732 0.5269952019888732 0.5269939355188407 7.820895665533456e-07 -0.011089310198717362 -0.0733 0.5270307961846852 0.5270295165507706 7.797600893866274e-07 -0.011104314288691209 -0.0734 0.5270663867605722 0.5270650939960451 7.773249552922579e-07 -0.011119317872511005 -0.0735 0.5271019737148283 0.5271006678546669 7.747843916439123e-07 -0.011134320949509918 -0.07360000000000001 0.5271375570457499 0.5271362381266372 7.721386397485652e-07 -0.011149323519021238 -0.0737 0.527173136751635 0.5271718048119562 7.693879547909788e-07 -0.01116432558037826 -0.07379999999999999 0.5272087128307835 0.5272073679106232 7.665326056116584e-07 -0.011179327132914453 -0.07390000000000001 0.5272442852814978 0.5272429274226352 7.635728748733861e-07 -0.01119432817596337 -0.074 0.5272798541020824 0.5272784833479888 7.605090590057095e-07 -0.011209328708858641 -0.07410000000000001 0.5273154192908442 0.5273140356866781 7.573414681494306e-07 -0.01122432873093398 -0.0742 0.5273509808460927 0.5273495844386957 7.540704262676279e-07 -0.01123932824152319 -0.07429999999999999 0.5273865387661397 0.5273851296040323 7.506962708681009e-07 -0.011254327239960138 -0.07440000000000001 0.5274220930493002 0.5274206711826765 7.472193530588811e-07 -0.011269325725578889 -0.0745 0.5274576436938918 0.5274562091746153 7.436400376592545e-07 -0.011284323697713483 -0.07460000000000001 0.5274931906982349 0.5274917435798332 7.399587030887389e-07 -0.011299321155698129 -0.0747 0.527528734060653 0.527527274398312 7.361757414781067e-07 -0.011314318098867111 -0.07479999999999999 0.527564273779473 0.5275628016300319 7.322915583363176e-07 -0.011329314526554774 -0.07490000000000001 0.5275998098530249 0.52759832527497 7.283065723839854e-07 -0.011344310438095579 -0.075 0.5276353422796423 0.5276338453331006 7.242212162750228e-07 -0.011359305832824119 -0.07510000000000001 0.5276708710576619 0.5276693618043959 7.200359356529518e-07 -0.011374300710074982 -0.0752 0.5277063961854241 0.5277048746888248 7.157511897060154e-07 -0.011389295069182966 -0.07529999999999999 0.5277419176612734 0.5277403839863534 7.113674507230883e-07 -0.011404288909482908 -0.07540000000000001 0.5277774354835579 0.5277758896969444 7.068852045932772e-07 -0.011419282230309719 -0.0755 0.5278129496506294 0.527811391820558 7.02304950084276e-07 -0.011434275030998427 -0.07560000000000001 0.527848460160844 0.5278468903571504 6.976271994529881e-07 -0.011449267310884137 -0.0757 0.5278839670125617 0.5278823853066745 6.928524777793932e-07 -0.011464259069302086 -0.07579999999999999 0.5279194702041473 0.5279178766690803 6.879813234106358e-07 -0.011479250305587569 -0.07590000000000001 0.5279549697339696 0.5279533644443134 6.830142874059142e-07 -0.01149424101907598 -0.076 0.5279904656004017 0.5279888486323162 6.779519340915918e-07 -0.01150923120910285 -0.07610000000000001 0.5280259578018216 0.5280243292330271 6.727948405060857e-07 -0.011524220875003755 -0.0762 0.5280614463366118 0.5280598062463807 6.675435963998666e-07 -0.011539210016114377 -0.07629999999999999 0.5280969312031595 0.5280952796723073 6.621988045685256e-07 -0.01155419863177048 -0.07640000000000001 0.5281324123998571 0.5281307495107331 6.567610802976631e-07 -0.011569186721307974 -0.0765 0.528167889925102 0.5281662157615805 6.512310514739106e-07 -0.011584174284062826 -0.07660000000000002 0.5282033637772963 0.5282016784247668 6.456093585294198e-07 -0.011599161319371094 -0.0767 0.5282388339548476 0.5282371375002055 6.398966546083962e-07 -0.011614147826568933 -0.07680000000000001 0.5282743004561689 0.5282725929878052 6.340936050119872e-07 -0.011629133804992621 -0.07690000000000001 0.5283097632796782 0.5283080448874699 6.282008874758382e-07 -0.011644119253978485 -0.077 0.5283452224237996 0.5283434931990989 6.222191920590703e-07 -0.011659104172863 -0.0771 0.5283806778869622 0.5283789379225866 6.161492209777464e-07 -0.011674088560982693 -0.0772 0.5284161296676015 0.5284143790578224 6.099916883828271e-07 -0.011689072417674223 -0.07730000000000001 0.5284515777641585 0.5284498166046908 6.037473206932376e-07 -0.011704055742274344 -0.07740000000000001 0.5284870221750797 0.5284852505630707 5.974168560962667e-07 -0.011719038534119836 -0.0775 0.5285224628988182 0.5285206809328362 5.910010447141012e-07 -0.011734020792547668 -0.0776 0.528557899933833 0.5285561077138559 5.845006486593363e-07 -0.011749002516894853 -0.0777 0.5285933332785893 0.5285915309059929 5.77916441368842e-07 -0.011763983706498508 -0.07780000000000001 0.5286287629315586 0.5286269505091046 5.71249208020097e-07 -0.011778964360695872 -0.07790000000000001 0.5286641888912191 0.528662366523043 5.644997454756773e-07 -0.011793944478824245 -0.078 0.528699611156055 0.5286977789476542 5.576688616726333e-07 -0.011808924060221056 -0.0781 0.5287350297245577 0.5287331877827787 5.507573761220907e-07 -0.011823903104223791 -0.0782 0.5287704445952244 0.5287685930282505 5.437661195761834e-07 -0.01183888161017008 -0.07830000000000001 0.52880585576656 0.5288039946838982 5.366959338892752e-07 -0.011853859577397624 -0.07840000000000001 0.528841263237076 0.528839392749544 5.295476718514269e-07 -0.011868837005244215 -0.0785 0.5288766670052907 0.5288747872250036 5.223221972161518e-07 -0.011883813893047762 -0.0786 0.5289120670697295 0.528910178110087 5.150203847004153e-07 -0.011898790240146269 -0.0787 0.5289474634289252 0.5289455654045973 5.076431197348352e-07 -0.01191376604587782 -0.07880000000000001 0.5289828560814176 0.5289809491083313 5.001912982138812e-07 -0.01192874130958061 -0.07890000000000001 0.529018245025754 0.529016329221079 4.926658266346529e-07 -0.011943716030592928 -0.079 0.529053630260489 0.5290517057426241 4.850676219581018e-07 -0.011958690208253171 -0.0791 0.5290890117841848 0.5290870786727434 4.773976114702538e-07 -0.011973663841899818 -0.0792 0.5291243895954109 0.5291224480112067 4.696567325324086e-07 -0.011988636930871446 -0.07930000000000001 0.5291597636927451 0.529157813757777 4.618459328031843e-07 -0.012003609474506766 -0.07940000000000001 0.5291951340747726 0.5291931759122104 4.539661697111619e-07 -0.012018581472144541 -0.0795 0.5292305007400862 0.5292285344742556 4.4601841048264035e-07 -0.012033552923123653 -0.0796 0.5292658636872872 0.5292638894436543 4.380036324469483e-07 -0.012048523826783062 -0.07970000000000001 0.5293012229149845 0.529299240820141 4.2992282220377653e-07 -0.01206349418246188 -0.07980000000000001 0.5293365784217953 0.529334588603443 4.2177697590073393e-07 -0.012078463989499265 -0.0799 0.5293719302063449 0.5293699327932796 4.1356709931661406e-07 -0.012093433247234501 -0.08 0.5294072782672669 0.5294052733893629 4.0529420719526144e-07 -0.012108401955006965 -0.0801 0.5294426226032033 0.5294406103913979 3.9695932349537166e-07 -0.012123370112156126 -0.08020000000000001 0.5294779632128045 0.5294759437990813 3.885634813349803e-07 -0.012138337718021575 -0.08030000000000001 0.5295133000947293 0.5295112736121019 3.8010772260288483e-07 -0.012153304771942963 -0.0804 0.5295486332476451 0.5295465998301415 3.715930979586446e-07 -0.01216827127326007 -0.0805 0.529583962670228 0.5295819224528735 3.6302066669380295e-07 -0.012183237221312768 -0.0806 0.5296192883611628 0.5296172414799631 3.543914965931094e-07 -0.012198202615441031 -0.08070000000000001 0.5296546103191433 0.529652556911068 3.4570666396227523e-07 -0.012213167454984943 -0.08080000000000001 0.5296899285428717 0.5296878687458376 3.3696725321163967e-07 -0.01222813173928467 -0.0809 0.5297252430310596 0.5297231769839128 3.281743567729034e-07 -0.012243095467680487 -0.081 0.5297605537824275 0.5297584816249266 3.193290752379063e-07 -0.01225805863951276 -0.0811 0.5297958607957045 0.5297937826685039 3.104325168590272e-07 -0.012273021254121962 -0.08120000000000001 0.5298311640696296 0.5298290801142607 3.0148579779898377e-07 -0.01228798331084868 -0.08130000000000001 0.5298664636029506 0.5298643739618047 2.92490041603477e-07 -0.012302944809033586 -0.0814 0.5299017593944247 0.5298996642107351 2.834463792844577e-07 -0.01231790574801745 -0.0815 0.5299370514428183 0.5299349508606428 2.7435594915359296e-07 -0.01233286612714115 -0.0816 0.5299723397469073 0.5299702339111098 2.652198967251218e-07 -0.012347825945745674 -0.08170000000000001 0.5300076243054771 0.5300055133617091 2.56039374396666e-07 -0.01236278520317209 -0.08180000000000001 0.5300429051173224 0.5300407892120055 2.468155414908635e-07 -0.01237774389876158 -0.0819 0.5300781821812479 0.5300760614615546 2.375495640333236e-07 -0.012392702031855427 -0.082 0.5301134554960679 0.5301113301099035 2.2824261462772721e-07 -0.012407659601795018 -0.0821 0.5301487250606058 0.53014659515659 2.188958722615375e-07 -0.012422616607921839 -0.08220000000000001 0.5301839908736953 0.5301818566011427 2.095105221949778e-07 -0.012437573049577464 -0.08230000000000001 0.5302192529341798 0.5302171144430816 2.0008775578062021e-07 -0.012452528926103596 -0.0824 0.5302545112409128 0.5302523686819174 1.9062877046338578e-07 -0.012467484236842012 -0.0825 0.5302897657927572 0.5302876193171517 1.8113476937808848e-07 -0.012482438981134606 -0.0826 0.5303250165885866 0.5303228663482769 1.7160696130780195e-07 -0.012497393158323378 -0.08270000000000001 0.5303602636272838 0.5303581097747758 1.620465606561039e-07 -0.012512346767750425 -0.08280000000000001 0.5303955069077424 0.5303933495961227 1.5245478712788696e-07 -0.012527299808757941 -0.0829 0.5304307464288656 0.5304285858117816 1.4283286567384756e-07 -0.012542252280688233 -0.083 0.5304659821895671 0.5304638184212075 1.3318202633783027e-07 -0.012557204182883695 -0.08310000000000001 0.5305012141887706 0.530499047423846 1.2350350389600528e-07 -0.012572155514686845 -0.0832 0.5305364424254105 0.5305342728191335 1.1379853798176853e-07 -0.012587106275440295 -0.08330000000000001 0.5305716668984308 0.5305694946064962 1.0406837277349146e-07 -0.012602056464486745 -0.0834 0.5306068876067862 0.5306047127853508 9.431425690431539e-08 -0.012617006081169014 -0.0835 0.530642104549442 0.530639927355105 8.453744324704582e-08 -0.01263195512483002 -0.08360000000000001 0.5306773177253739 0.5306751383151561 7.473918878925234e-08 -0.012646903594812796 -0.0837 0.5307125271335674 0.5307103456648923 6.49207544320407e-08 -0.012661851490460455 -0.08380000000000001 0.5307477327730195 0.5307455494036916 5.508340487903052e-08 -0.012676798811116222 -0.0839 0.5307829346427368 0.5307807495309226 4.522840842818843e-08 -0.012691745556123442 -0.084 0.5308181327417375 0.5308159460459437 3.535703686774472e-08 -0.012706691724825546 -0.08410000000000001 0.5308533270690494 0.5308511389481042 2.5470565240270915e-08 -0.012721637316566071 -0.0842 0.5308885176237113 0.5308863282367424 1.557027173165748e-08 -0.01273658233068866 -0.08430000000000001 0.530923704404773 0.5309215139111872 5.657437501110918e-09 -0.012751526766537067 -0.0844 0.5309588874112946 0.5309566959707582 -4.2666535270130534e-09 -0.012766470623455135 -0.0845 0.5309940666423472 0.5309918744147644 -1.4200714770762346e-08 -0.012781413900786825 -0.08460000000000001 0.5310292420970123 0.5310270492425045 -2.4143457207428942e-08 -0.0127963565978762 -0.0847 0.5310644137743825 0.5310622204532682 -3.409358950018371e-08 -0.012811298714067427 -0.08480000000000001 0.531099581673561 0.5310973880463344 -4.404981819149806e-08 -0.012826240248704771 -0.0849 0.5311347457936618 0.5311325520209721 -5.4010847855799626e-08 -0.012841181201132604 -0.085 0.5311699061338102 0.5311677123764401 -6.397538127728142e-08 -0.01285612157069541 -0.08510000000000001 0.5312050626931417 0.5312028691119873 -7.394211962163943e-08 -0.012871061356737771 -0.0852 0.531240215470803 0.5312380222268525 -8.390976259479987e-08 -0.012886000558604373 -0.08530000000000001 0.5312753644659518 0.5312731717202642 -9.387700862679982e-08 -0.012900939175640011 -0.0854 0.5313105096777565 0.5313083175914413 -1.0384255501316719e-07 -0.012915877207189591 -0.0855 0.5313456511053967 0.5313434598395915 -1.1380509812655704e-07 -0.012930814652598113 -0.08560000000000001 0.5313807887480626 0.5313785984639134 -1.2376333356073355e-07 -0.012945751511210688 -0.0857 0.5314159226049557 0.5314137334635949 -1.3371595630057298e-07 -0.01296068778237254 -0.08580000000000002 0.531451052675288 0.5314488648378135 -1.4366166090767907e-07 -0.012975623465428979 -0.0859 0.531486178958283 0.5314839925857369 -1.5359914166956923e-07 -0.012990558559725435 -0.086 0.5315213014531748 0.5315191167065225 -1.6352709279743305e-07 -0.013005493064607446 -0.08610000000000001 0.5315564201592085 0.5315542371993174 -1.7344420857184906e-07 -0.013020426979420647 -0.0862 0.5315915350756405 0.5315893540632585 -1.8334918357176822e-07 -0.01303536030351079 -0.08630000000000002 0.5316266462017378 0.5316244672974724 -1.9324071275084176e-07 -0.013050293036223721 -0.0864 0.5316617535367789 0.5316595769010759 -2.0311749170109916e-07 -0.013065225176905402 -0.0865 0.5316968570800525 0.5316946828731749 -2.1297821673621486e-07 -0.013080156724901893 -0.08660000000000001 0.5317319568308592 0.5317297852128656 -2.2282158522457518e-07 -0.013095087679559372 -0.0867 0.5317670527885099 0.5317648839192338 -2.3264629551988936e-07 -0.013110018040224115 -0.08680000000000002 0.5318021449523268 0.531799978991355 -2.4245104733588985e-07 -0.01312494780624251 -0.0869 0.5318372333216432 0.5318350704282946 -2.522345418504157e-07 -0.013139876976961047 -0.087 0.531872317895803 0.5318701582291078 -2.619954818927628e-07 -0.013154805551726316 -0.08710000000000001 0.5319073986741613 0.5319052423928398 -2.717325720963393e-07 -0.01316973352988504 -0.0872 0.5319424756560841 0.531940322918525 -2.814445190374437e-07 -0.013184660910784025 -0.08730000000000002 0.5319775488409482 0.5319753998051883 -2.9113003144343175e-07 -0.013199587693770186 -0.0874 0.5320126182281416 0.532010473051844 -3.007878204425163e-07 -0.013214513878190563 -0.0875 0.5320476838170632 0.5320455426574966 -3.104165995915231e-07 -0.013229439463392278 -0.08760000000000001 0.532082745607123 0.5320806086211403 -3.2001508519508004e-07 -0.013244364448722595 -0.0877 0.532117803597741 0.532115670941759 -3.295819963056168e-07 -0.013259288833528844 -0.08780000000000002 0.5321528577883489 0.5321507296183268 -3.391160550980654e-07 -0.013274212617158498 -0.0879 0.5321879081783889 0.5321857846498073 -3.48615986814349e-07 -0.013289135798959123 -0.088 0.5322229547673144 0.5322208360351549 -3.580805201519599e-07 -0.013304058378278392 -0.08810000000000001 0.5322579975545891 0.5322558837733131 -3.6750838731947066e-07 -0.01331898035446409 -0.0882 0.532293036539688 0.5322909278632159 -3.768983241891899e-07 -0.013333901726864114 -0.08830000000000002 0.5323280717220962 0.5323259683037868 -3.862490705885957e-07 -0.013348822494826457 -0.0884 0.5323631031013101 0.5323610050939399 -3.955593703142135e-07 -0.013363742657699238 -0.0885 0.5323981306768366 0.532396038232579 -4.0482797136753845e-07 -0.013378662214830661 -0.08860000000000001 0.5324331544481933 0.5324310677185982 -4.140536262742245e-07 -0.013393581165569069 -0.0887 0.5324681744149083 0.5324660935508815 -4.2323509191755093e-07 -0.01340849950926289 -0.08880000000000002 0.5325031905765207 0.5325011157283035 -4.3237112995475613e-07 -0.013423417245260666 -0.0889 0.5325382029325797 0.5325361342497287 -4.414605071778599e-07 -0.013438334372911063 -0.089 0.5325732114826452 0.5325711491140118 -4.5050199504181876e-07 -0.013453250891562832 -0.08910000000000001 0.5326082162262877 0.5326061603199977 -4.594943704139265e-07 -0.013468166800564858 -0.0892 0.5326432171630882 0.5326411678665219 -4.684364156848364e-07 -0.01348308209926611 -0.08930000000000002 0.532678214292638 0.53267617175241 -4.773269186852946e-07 -0.013497996787015694 -0.08940000000000001 0.5327132076145387 0.5327111719764782 -4.86164672824918e-07 -0.013512910863162792 -0.0895 0.5327481971284025 0.5327461685375328 -4.949484776195501e-07 -0.013527824327056731 -0.08960000000000001 0.5327831828338518 0.5327811614343708 -5.036771385802385e-07 -0.013542737178046932 -0.0897 0.5328181647305194 0.5328161506657799 -5.123494674075246e-07 -0.013557649415482934 -0.0898 0.5328531428180476 0.532851136230538 -5.209642821579763e-07 -0.013572561038714355 -0.08990000000000001 0.5328881170960901 0.5328861181274138 -5.295204075772553e-07 -0.013587472047090987 -0.09 0.5329230875643096 0.5329210963551664 -5.380166750168502e-07 -0.01360238243996265 -0.09010000000000001 0.5329580542223795 0.532956070912546 -5.464519226561215e-07 -0.013617292216679339 -0.0902 0.532993017069983 0.5329910417982935 -5.548249957798568e-07 -0.013632201376591125 -0.0903 0.5330279761068133 0.5330260090111402 -5.631347468337822e-07 -0.013647109919048212 -0.09040000000000001 0.5330629313325732 0.5330609725498089 -5.71380035646607e-07 -0.013662017843400901 -0.0905 0.5330978827469759 0.5330959324130126 -5.795597294855348e-07 -0.013676925148999609 -0.09060000000000001 0.5331328303497439 0.5331308885994561 -5.87672703278308e-07 -0.01369183183519486 -0.0907 0.5331677741406099 0.5331658411078345 -5.957178399185192e-07 -0.013706737901337297 -0.0908 0.533202714119316 0.5332007899368344 -6.036940301823446e-07 -0.013721643346777666 -0.09090000000000001 0.5332376502856139 0.5332357350851336 -6.116001728395659e-07 -0.013736548170866834 -0.091 0.5332725826392649 0.5332706765514007 -6.194351752919491e-07 -0.013751452372955764 -0.09110000000000001 0.5333075111800399 0.533305614334296 -6.271979531569105e-07 -0.01376635595239554 -0.0912 0.5333424359077191 0.5333405484324711 -6.348874306560948e-07 -0.013781258908537356 -0.0913 0.5333773568220923 0.5333754788445688 -6.425025406708862e-07 -0.01379616124073253 -0.09140000000000001 0.5334122739229581 0.5334104055692238 -6.500422251864979e-07 -0.01381106294833249 -0.0915 0.5334471872101247 0.5334453286050617 -6.575054350976828e-07 -0.013825964030688748 -0.09160000000000001 0.5334820966834096 0.5334802479507 -6.64891130569556e-07 -0.013840864487152944 -0.0917 0.533517002342639 0.5335151636047485 -6.721982810098392e-07 -0.013855764317076856 -0.0918 0.5335519041876482 0.5335500755658076 -6.794258653741725e-07 -0.013870663519812323 -0.09190000000000001 0.5335868022182818 0.5335849838324707 -6.865728721106024e-07 -0.01388556209471134 -0.092 0.533621696434393 0.5336198884033222 -6.936382998812274e-07 -0.013900460041126009 -0.09210000000000002 0.5336565868358434 0.5336547892769389 -7.006211566740195e-07 -0.013915357358408523 -0.0922 0.533691473422504 0.5336896864518897 -7.07520460913047e-07 -0.013930254045911201 -0.09230000000000001 0.5337263561942542 0.5337245799267357 -7.143352411254078e-07 -0.013945150102986493 -0.09240000000000001 0.5337612351509818 0.5337594697000299 -7.210645361355184e-07 -0.013960045528986909 -0.0925 0.5337961102925832 0.5337943557703176 -7.277073953981805e-07 -0.013974940323265135 -0.0926 0.5338309816189631 0.5338292381361369 -7.342628787210259e-07 -0.01398983448517392 -0.0927 0.533865849130035 0.5338641167960182 -7.407300569028941e-07 -0.014004728014066176 -0.09280000000000001 0.5339007128257198 0.5338989917484844 -7.471080114562767e-07 -0.014019620909294872 -0.09290000000000001 0.5339355727059469 0.5339338629920507 -7.533958351624293e-07 -0.01403451317021311 -0.093 0.533970428770654 0.5339687305252255 -7.595926315717705e-07 -0.014049404796174132 -0.0931 0.5340052810197866 0.53400359434651 -7.656975157810386e-07 -0.014064295786531289 -0.0932 0.5340401294532982 0.5340384544543982 -7.717096142667579e-07 -0.014079186140638045 -0.09330000000000001 0.5340749740711496 0.5340733108473766 -7.776280648297274e-07 -0.0140940758578479 -0.09340000000000001 0.53410981487331 0.5341081635239256 -7.834520173166659e-07 -0.014108964937514585 -0.0935 0.5341446518597559 0.5341430124825183 -7.891806330651008e-07 -0.014123853378991903 -0.0936 0.5341794850304711 0.534177857721621 -7.948130854029678e-07 -0.01413874118163374 -0.0937 0.5342143143854472 0.5342126992396934 -8.003485595931004e-07 -0.014153628344794134 -0.09380000000000001 0.534249139924683 0.5342475370351889 -8.057862533328297e-07 -0.01416851486782721 -0.09390000000000001 0.5342839616481843 0.5342823711065545 -8.111253761433623e-07 -0.014183400750087222 -0.094 0.5343187795559644 0.5343172014522303 -8.163651504244918e-07 -0.014198285990928533 -0.0941 0.5343535936480432 0.5343520280706506 -8.215048107329537e-07 -0.014213170589705632 -0.0942 0.5343884039244481 0.5343868509602434 -8.265436041154928e-07 -0.0142280545457731 -0.09430000000000001 0.5344232103852129 0.5344216701194306 -8.314807908860189e-07 -0.01424293785848569 -0.09440000000000001 0.5344580130303783 0.5344564855466283 -8.363156439039621e-07 -0.01425782052719819 -0.0945 0.5344928118599918 0.5344912972402467 -8.41047448740806e-07 -0.014272702551265566 -0.0946 0.5345276068741068 0.53452610519869 -8.456755043462216e-07 -0.014287583930042863 -0.0947 0.5345623980727842 0.5345609094203572 -8.501991227705119e-07 -0.014302464662885256 -0.09480000000000001 0.5345971854560903 0.5345957099036411 -8.546176293866559e-07 -0.01431734474914802 -0.09490000000000001 0.5346319690240977 0.5346305066469298 -8.589303626682643e-07 -0.014332224188186561 -0.095 0.5346667487768857 0.5346652996486055 -8.631366748002023e-07 -0.014347102979356402 -0.0951 0.534701524714539 0.5347000889070456 -8.672359314565448e-07 -0.01436198112201318 -0.0952 0.5347362968371489 0.5347348744206222 -8.712275121891544e-07 -0.014376858615512701 -0.09530000000000001 0.5347710651448114 0.5347696561877022 -8.751108100391036e-07 -0.014391735459210759 -0.09540000000000001 0.5348058296376293 0.5348044342066478 -8.788852319252527e-07 -0.014406611652463354 -0.0955 0.5348405903157105 0.5348392084758166 -8.825501988662943e-07 -0.01442148719462661 -0.0956 0.5348753471791681 0.5348739789935609 -8.861051460917757e-07 -0.014436362085056727 -0.09570000000000001 0.5349101002281209 0.5349087457582292 -8.89549522264943e-07 -0.014451236323110045 -0.09580000000000001 0.5349448494626927 0.5349435087681652 -8.928827909260306e-07 -0.01446610990814301 -0.0959 0.5349795948830129 0.5349782680217081 -8.961044295485721e-07 -0.014480982839512175 -0.096 0.5350143364892155 0.5350130235171933 -8.992139305386004e-07 -0.01449585511657427 -0.0961 0.5350490742814389 0.5350477752529514 -9.02210800290959e-07 -0.014510726738686048 -0.09620000000000001 0.5350838082598274 0.53508252322731 -9.050945597999238e-07 -0.014525597705204436 -0.09630000000000001 0.5351185384245292 0.5351172674385919 -9.078647447702259e-07 -0.014540468015486524 -0.0964 0.535153264775697 0.5351520078851164 -9.105209058390962e-07 -0.014555337668889374 -0.0965 0.5351879873134886 0.5351867445651999 -9.130626080211535e-07 -0.014570206664770331 -0.0966 0.5352227060380652 0.5352214774771541 -9.154894313190276e-07 -0.014585075002486753 -0.09670000000000001 0.5352574209495927 0.5352562066192883 -9.178009706123369e-07 -0.014599942681396166 -0.09680000000000001 0.5352921320482411 0.5352909319899077 -9.19996835935244e-07 -0.014614809700856164 -0.0969 0.5353268393341839 0.5353256535873152 -9.220766523099222e-07 -0.01462967606022448 -0.097 0.5353615428075991 0.5353603714098097 -9.240400599130894e-07 -0.014644541758858971 -0.0971 0.5353962424686678 0.5353950854556881 -9.258867143535632e-07 -0.014659406796117685 -0.09720000000000001 0.5354309383175753 0.5354297957232441 -9.276162858395942e-07 -0.014674271171358678 -0.09730000000000001 0.5354656303545092 0.5354645022107685 -9.292284604001111e-07 -0.014689134883940093 -0.0974 0.5355003185796618 0.5354992049165498 -9.307229392185867e-07 -0.014703997933220343 -0.0975 0.5355350029932276 0.5355339038388744 -9.320994390216164e-07 -0.014718860318557837 -0.0976 0.5355696835954051 0.5355685989760262 -9.333576919123843e-07 -0.014733722039311198 -0.09770000000000001 0.5356043603863947 0.5356032903262861 -9.344974455371968e-07 -0.01474858309483907 -0.09780000000000001 0.5356390333664003 0.5356379778879343 -9.355184631409941e-07 -0.014763443484500255 -0.0979 0.5356737025356282 0.5356726616592483 -9.36420523733883e-07 -0.014778303207653687 -0.098 0.5357083678942877 0.5357073416385041 -9.372034217580705e-07 -0.014793162263658394 -0.0981 0.53574302944259 0.5357420178239758 -9.378669673654194e-07 -0.014808020651873583 -0.09820000000000001 0.5357776871807489 0.535776690213936 -9.384109865839818e-07 -0.014822878371658516 -0.09830000000000001 0.5358123411089807 0.5358113588066562 -9.388353212624878e-07 -0.014837735422372584 -0.0984 0.5358469912275032 0.5358460236004065 -9.391398289593234e-07 -0.014852591803375344 -0.0985 0.5358816375365363 0.5358806845934552 -9.393243829980413e-07 -0.014867447514026334 -0.09860000000000001 0.5359162800363018 0.5359153417840707 -9.393888728004285e-07 -0.01488230255368543 -0.0987 0.5359509187270233 0.5359499951705196 -9.393332035534385e-07 -0.014897156921712463 -0.09880000000000001 0.5359855536089257 0.5359846447510683 -9.391572964867478e-07 -0.014912010617467459 -0.0989 0.5360201846822356 0.5360192905239822 -9.388610888172444e-07 -0.014926863640310501 -0.099 0.5360548119471804 0.5360539324875266 -9.384445336935165e-07 -0.014941715989601846 -0.09910000000000001 0.5360894354039892 0.5360885706399662 -9.379076003623865e-07 -0.01495656766470188 -0.0992 0.5361240550528918 0.5361232049795652 -9.372502738913546e-07 -0.01497141866497106 -0.09930000000000001 0.5361586708941193 0.5361578355045877 -9.364725556681996e-07 -0.01498626898976998 -0.0994 0.5361932829279026 0.5361924622132986 -9.355744630124008e-07 -0.015001118638459389 -0.0995 0.5362278911544744 0.5362270851039623 -9.34556029341671e-07 -0.015015967610400117 -0.09960000000000001 0.5362624955740674 0.5362617041748434 -9.334173043940019e-07 -0.015030815904953105 -0.0997 0.5362970961869145 0.5362963194242074 -9.32158353339485e-07 -0.01504566352147947 -0.09980000000000001 0.5363316929932489 0.5363309308503198 -9.307792583346242e-07 -0.01506051045934036 -0.0999 0.5363662859933042 0.5363655384514474 -9.292801172455789e-07 -0.015075356717897177 -0.1 0.5364008751873134 0.5364001422258572 -9.276610441477651e-07 -0.01509020229651132 -0.10010000000000001 0.5364354605755103 0.5364347421718174 -9.259221688817654e-07 -0.015105047194544375 -0.1002 0.5364700421581274 0.5364693382875976 -9.24063637608441e-07 -0.015119891411358007 -0.10030000000000001 0.5365046199353973 0.5365039305714681 -9.220856129754651e-07 -0.01513473494631406 -0.1004 0.536539193907552 0.5365385190217007 -9.199882733956777e-07 -0.01514957779877446 -0.1005 0.5365737640748227 0.5365731036365688 -9.177718133246415e-07 -0.015164419968101245 -0.10060000000000001 0.5366083304374398 0.5366076844143476 -9.154364433716644e-07 -0.015179261453656624 -0.1007 0.5366428929956328 0.5366422613533135 -9.129823901887768e-07 -0.015194102254802867 -0.10080000000000001 0.5366774517496302 0.5366768344517451 -9.104098968037988e-07 -0.015208942370902374 -0.1009 0.5367120066996591 0.5367114037079229 -9.077192218986951e-07 -0.015223781801317705 -0.101 0.5367465578459454 0.5367459691201297 -9.049106402536644e-07 -0.015238620545411542 -0.10110000000000001 0.5367811051887134 0.5367805306866507 -9.019844429136725e-07 -0.015253458602546639 -0.1012 0.5368156487281858 0.536815088405773 -8.989409364668077e-07 -0.015268295972085944 -0.10130000000000002 0.5368501884645837 0.5368496422757866 -8.957804438214367e-07 -0.015283132653392468 -0.1014 0.5368847243981262 0.5368841922949841 -8.925033038176267e-07 -0.015297968645829364 -0.1015 0.5369192565290306 0.5369187384616609 -8.891098707275447e-07 -0.01531280394875993 -0.10160000000000001 0.5369537848575116 0.5369532807741153 -8.856005153101698e-07 -0.015327638561547558 -0.1017 0.536988309383782 0.5369878192306485 -8.819756237010701e-07 -0.015342472483555754 -0.10180000000000002 0.537022830108052 0.5370223538295654 -8.782355980785361e-07 -0.015357305714148152 -0.1019 0.5370573470305294 0.5370568845691737 -8.743808563305144e-07 -0.015372138252688529 -0.102 0.5370918601514193 0.5370914114477846 -8.704118318880738e-07 -0.015386970098540776 -0.10210000000000001 0.5371263694709243 0.5371259344637133 -8.663289740584723e-07 -0.015401801251068954 -0.1022 0.5371608749892435 0.5371604536152782 -8.621327474700458e-07 -0.01541663170963713 -0.10230000000000002 0.5371953767065734 0.537194968900802 -8.578236327383415e-07 -0.015431461473609616 -0.1024 0.5372298746231071 0.5372294803186111 -8.534021260220293e-07 -0.015446290542350784 -0.1025 0.5372643687390346 0.537263987867036 -8.488687383567672e-07 -0.015461118915225142 -0.10260000000000001 0.537298859054542 0.5372984915444116 -8.442239968764476e-07 -0.015475946591597345 -0.1027 0.5373333455698123 0.5373329913490769 -8.39468443647462e-07 -0.015490773570832117 -0.10280000000000002 0.5373678282850247 0.5373674872793756 -8.346026361683023e-07 -0.01550559985229435 -0.1029 0.5374023072003546 0.5374019793336557 -8.296271473140493e-07 -0.015520425435349062 -0.103 0.5374367823159734 0.5374364675102704 -8.245425651143279e-07 -0.015535250319361356 -0.10310000000000001 0.5374712536320483 0.5374709518075779 -8.193494924202405e-07 -0.015550074503696498 -0.1032 0.5375057211487424 0.5375054322239404 -8.140485474039671e-07 -0.015564897987719884 -0.10330000000000002 0.5375401848662146 0.5375399087577264 -8.086403631701877e-07 -0.015579720770796996 -0.1034 0.5375746447846191 0.5375743814073088 -8.031255878115928e-07 -0.015594542852293492 -0.1035 0.537609100904106 0.5376088501710664 -7.975048841868393e-07 -0.015609364231575107 -0.10360000000000001 0.53764355322482 0.5376433150473829 -7.917789296985056e-07 -0.015624184908007717 -0.1037 0.5376780017469014 0.5376777760346485 -7.859484170147368e-07 -0.01563900488095731 -0.10380000000000002 0.5377124464704855 0.5377122331312583 -7.800140529035104e-07 -0.01565382414979004 -0.1039 0.5377468873957028 0.5377466863356135 -7.739765587877478e-07 -0.01566864271387214 -0.104 0.537781324522678 0.5377811356461215 -7.678366706342921e-07 -0.01568346057257 -0.10410000000000001 0.537815757851531 0.5378155810611958 -7.615951386208408e-07 -0.015698277725250127 -0.1042 0.537850187382376 0.5378500225792557 -7.552527273024801e-07 -0.01571309417127915 -0.10430000000000002 0.5378846131153218 0.5378844601987274 -7.488102152231058e-07 -0.015727909910023815 -0.1044 0.5379190350504716 0.5379188939180433 -7.422683953595133e-07 -0.015742724940851004 -0.1045 0.5379534531879223 0.5379533237356421 -7.356280745107746e-07 -0.015757539263127725 -0.10460000000000001 0.5379878675277656 0.5379877496499699 -7.288900731872161e-07 -0.015772352876221113 -0.1047 0.538022278070087 0.5380221716594791 -7.220552259989965e-07 -0.015787165779498444 -0.10480000000000002 0.5380566848149655 0.538056589762629 -7.151243811842622e-07 -0.015801977972327092 -0.10490000000000001 0.5380910877624742 0.5380910039578861 -7.080984006091473e-07 -0.01581678945407456 -0.105 0.5381254869126796 0.5381254142437242 -7.009781594347064e-07 -0.01583160022410848 -0.10510000000000001 0.5381598822656417 0.538159820618624 -6.93764546449982e-07 -0.015846410281796623 -0.1052 0.5381942738214143 0.5381942230810739 -6.864584635724036e-07 -0.01586121962650687 -0.1053 0.5382286615800441 0.5382286216295697 -6.790608260975883e-07 -0.015876028257607266 -0.10540000000000001 0.538263045541571 0.538263016262615 -6.715725620887181e-07 -0.01589083617446593 -0.1055 0.5382974257060282 0.5382974069787207 -6.639946127651175e-07 -0.015905643376451135 -0.10560000000000001 0.5383318020734418 0.538331793776406 -6.563279322246984e-07 -0.015920449862931285 -0.1057 0.5383661746438305 0.5383661766541978 -6.485734871386484e-07 -0.0159352556332749 -0.1058 0.5384005434172061 0.5384005556106312 -6.407322569457197e-07 -0.01595006068685065 -0.10590000000000001 0.538434908393573 0.5384349306442492 -6.328052334081402e-07 -0.01596486502302731 -0.106 0.5384692695729276 0.5384693017536031 -6.247934206671246e-07 -0.015979668641173766 -0.10610000000000001 0.5385036269552594 0.5385036689372527 -6.166978354371633e-07 -0.015994471540659052 -0.1062 0.53853798054055 0.5385380321937665 -6.085195060623327e-07 -0.016009273720852354 -0.1063 0.5385723303287729 0.5385723915217211 -6.002594731269184e-07 -0.016024075181122945 -0.10640000000000001 0.5386066763198942 0.538606746919702 -5.919187889558142e-07 -0.016038875920840235 -0.1065 0.5386410185138719 0.5386410983863036 -5.83498517836567e-07 -0.016053675939373787 -0.10660000000000001 0.5386753569106557 0.5386754459201291 -5.749997352422209e-07 -0.01606847523609327 -0.1067 0.5387096915101872 0.5387097895197903 -5.664235284141839e-07 -0.016083273810368483 -0.1068 0.5387440223123999 0.5387441291839089 -5.577709960014055e-07 -0.016098071661569353 -0.10690000000000001 0.5387783493172187 0.5387784649111149 -5.490432475607765e-07 -0.01611286878906594 -0.107 0.5388126725245602 0.5388127967000483 -5.40241403751418e-07 -0.016127665192228437 -0.10710000000000001 0.5388469919343322 0.5388471245493581 -5.313665963069258e-07 -0.01614246087042714 -0.1072 0.5388813075464342 0.5388814484577027 -5.224199674802588e-07 -0.016157255823032516 -0.1073 0.5389156193607565 0.5389157684237498 -5.134026704323169e-07 -0.016172050049415115 -0.10740000000000001 0.5389499273771808 0.5389500844461775 -5.043158686490745e-07 -0.016186843548945645 -0.1075 0.5389842315955802 0.5389843965236731 -4.951607357750465e-07 -0.016201636320994944 -0.10760000000000002 0.5390185320158181 0.5390187046549336 -4.859384557798219e-07 -0.01621642836493396 -0.1077 0.5390528286377492 0.5390530088386664 -4.766502227637748e-07 -0.016231219680133798 -0.1078 0.5390871214612191 0.5390873090735886 -4.672972404584641e-07 -0.016246010265965644 -0.10790000000000001 0.5391214104860638 0.5391216053584273 -4.578807225041892e-07 -0.016260800121800884 -0.108 0.5391556957121101 0.5391558976919202 -4.484018920614119e-07 -0.016275589247010974 -0.1081 0.5391899771391754 0.5391901860728148 -4.388619816164674e-07 -0.01629037764096752 -0.1082 0.5392242547670674 0.5392244704998688 -4.292622330925866e-07 -0.016305165303042247 -0.10830000000000001 0.5392585285955843 0.5392587509718507 -4.1960389726702907e-07 -0.01631995223260705 -0.10840000000000001 0.5392927986245147 0.5392930274875395 -4.0988823379883854e-07 -0.016334738429033897 -0.1085 0.5393270648536374 0.5393273000457245 -4.0011651156190986e-07 -0.016349523891694914 -0.1086 0.539361327282721 0.5393615686452058 -3.9029000750701037e-07 -0.016364308619962364 -0.1087 0.5393955859115246 0.5393958332847942 -3.804100073556693e-07 -0.016379092613208635 -0.10880000000000001 0.5394298407397973 0.5394300939633112 -3.7047780490628845e-07 -0.016393875870806224 -0.10890000000000001 0.5394640917672779 0.5394643506795893 -3.6049470213128654e-07 -0.016408658392127795 -0.109 0.5394983389936953 0.5394986034324719 -3.504620090383215e-07 -0.016423440176546122 -0.1091 0.5395325824187678 0.5395328522208134 -3.403810432539567e-07 -0.016438221223434097 -0.1092 0.5395668220422039 0.5395670970434793 -3.302531300236611e-07 -0.016453001532164776 -0.10930000000000001 0.5396010578637014 0.5396013378993462 -3.2007960204527564e-07 -0.016467781102111313 -0.10940000000000001 0.5396352898829481 0.5396355747873017 -3.098617992053354e-07 -0.01648255993264701 -0.1095 0.5396695180996205 0.5396698077062453 -2.996010686068251e-07 -0.0164973380231453 -0.1096 0.5397037425133858 0.539704036655087 -2.8929876409733435e-07 -0.016512115372979735 -0.1097 0.5397379631238998 0.5397382616327491 -2.7895624631069094e-07 -0.016526891981524024 -0.10980000000000001 0.5397721799308074 0.5397724826381644 -2.685748823894052e-07 -0.016541667848151972 -0.10990000000000001 0.5398063929337434 0.539806699670278 -2.5815604579038087e-07 -0.01655644297223754 -0.11 0.5398406021323316 0.5398409127280461 -2.477011162571596e-07 -0.01657121735315482 -0.1101 0.539874807526185 0.5398751218104368 -2.3721147948685406e-07 -0.016585990990278014 -0.1102 0.5399090091149057 0.5399093269164297 -2.266885269774921e-07 -0.016600763882981484 -0.11030000000000001 0.5399432068980847 0.5399435280450164 -2.161336558476057e-07 -0.016615536030639717 -0.11040000000000001 0.5399774008753021 0.5399777251951999 -2.0554826869745302e-07 -0.016630307432627302 -0.1105 0.5400115910461272 0.5400119183659954 -1.9493377338697382e-07 -0.016645078088319006 -0.1106 0.5400457774101179 0.5400461075564298 -1.8429158279986702e-07 -0.016659847997089697 -0.1107 0.5400799599668215 0.540080292765542 -1.7362311478114067e-07 -0.016674617158314392 -0.11080000000000001 0.5401141387157733 0.5401144739923827 -1.6292979183180067e-07 -0.01668938557136822 -0.11090000000000001 0.5401483136564978 0.5401486512360149 -1.5221304097701172e-07 -0.01670415323562646 -0.111 0.5401824847885086 0.5401828244955134 -1.4147429355099161e-07 -0.016718920150464518 -0.1111 0.5402166521113072 0.5402169937699651 -1.3071498505129453e-07 -0.016733686315257925 -0.11120000000000001 0.5402508156243845 0.5402511590584694 -1.199365548543163e-07 -0.016748451729382365 -0.11130000000000001 0.5402849753272198 0.5402853203601379 -1.0914044615978336e-07 -0.01676321639221364 -0.1114 0.5403191312192805 0.5403194776740937 -9.832810567850236e-08 -0.01677798030312767 -0.1115 0.5403532833000235 0.5403536309994729 -8.750098348317414e-08 -0.01679274346150055 -0.1116 0.5403874315688934 0.5403877803354233 -7.666053283492125e-08 -0.016807505866708466 -0.11170000000000001 0.5404215760253236 0.5404219256811058 -6.580820994389613e-08 -0.016822267518127754 -0.11180000000000001 0.5404557166687358 0.5404560670356928 -5.494547382009496e-08 -0.01683702841513489 -0.1119 0.5404898534985405 0.5404902043983696 -4.407378605131296e-08 -0.01685178855710648 -0.112 0.5405239865141364 0.5405243377683338 -3.319461059844708e-08 -0.01686654794341925 -0.1121 0.5405581157149102 0.5405584671447949 -2.230941362896255e-08 -0.016881306573450074 -0.11220000000000001 0.5405922411002373 0.540592592526976 -1.1419663293980864e-08 -0.016896064446575952 -0.11230000000000001 0.5406263626694817 0.5406267139141115 -5.268295348581642e-10 -0.016910821562174022 -0.1124 0.5406604804219954 0.540660831305449 1.0367616110236455e-08 -0.016925577919621557 -0.1125 0.540694594357119 0.5406949447002483 2.1262200699742606e-08 -0.01694033351829597 -0.1126 0.5407287044741806 0.5407290540977815 3.215545010468168e-08 -0.016955088357574786 -0.11270000000000001 0.5407628107724974 0.540763159497334 4.304588918993546e-08 -0.01696984243683568 -0.11280000000000001 0.5407969132513745 0.5407972608982032 5.3932042030219174e-08 -0.01698459575545647 -0.1129 0.5408310119101052 0.540831358299699 6.481243209482956e-08 -0.016999348312815087 -0.113 0.5408651067479711 0.5408654517011441 7.568558245754642e-08 -0.017014100108289614 -0.1131 0.5408991977642421 0.5408995411018737 8.655001600826884e-08 -0.017028851141258253 -0.11320000000000001 0.540933284958176 0.5409336265012357 9.740425563342647e-08 -0.017043601411099365 -0.11330000000000001 0.5409673683290195 0.5409677078985902 1.0824682439292133e-07 -0.01705835091719141 -0.1134 0.5410014478760067 0.5410017852933106 1.1907624582890852e-07 -0.017073099658913012 -0.1135 0.5410355235983604 0.5410358586847823 1.298910440317158e-07 -0.017087847635642934 -0.1136 0.5410695954952915 0.5410699280724036 1.406897439173993e-07 -0.017102594846760046 -0.11370000000000001 0.5411036635659988 0.5411039934555852 1.5147087141509363e-07 -0.017117341291643363 -0.11380000000000001 0.5411377278096701 0.5411380548337503 1.622329536404843e-07 -0.01713208696967205 -0.1139 0.5411717882254803 0.5411721122063353 1.7297451922193563e-07 -0.017146831880225394 -0.114 0.5412058448125937 0.5412061655727884 1.836940982657964e-07 -0.017161576022682833 -0.11410000000000001 0.541239897570162 0.5412402149325711 1.943902228074279e-07 -0.017176319396423917 -0.1142 0.5412739464973254 0.5412742602851567 2.0506142683895945e-07 -0.01719106200082834 -0.11430000000000001 0.5413079915932124 0.5413083016300316 2.157062466284776e-07 -0.017205803835275948 -0.1144 0.5413420328569394 0.5413423389666948 2.2632322088655954e-07 -0.017220544899146695 -0.1145 0.5413760702876117 0.5413763722946574 2.369108908217843e-07 -0.0172352851918207 -0.11460000000000001 0.5414101038843223 0.5414104016134433 2.474678006542108e-07 -0.017250024712678193 -0.1147 0.5414441336461528 0.5414444269225891 2.5799249747660014e-07 -0.017264763461099557 -0.11480000000000001 0.5414781595721737 0.5414784482216434 2.684835316985046e-07 -0.017279501436465308 -0.1149 0.5415121816614427 0.5415124655101674 2.789394571017789e-07 -0.01729423863815609 -0.115 0.5415461999130066 0.5415464787877348 2.8935883115976946e-07 -0.017308975065552696 -0.11510000000000001 0.5415802143259003 0.5415804880539317 2.997402151483364e-07 -0.01732371071803603 -0.1152 0.5416142248991478 0.5416144933083566 3.100821744095317e-07 -0.01733844559498718 -0.11530000000000001 0.5416482316317605 0.5416484945506204 3.203832785458882e-07 -0.017353179695787313 -0.1154 0.5416822345227391 0.541682491780346 3.3064210139266415e-07 -0.01736791301981778 -0.1155 0.5417162335710727 0.5417164849971688 3.4085722162846555e-07 -0.01738264556646005 -0.11560000000000001 0.5417502287757385 0.5417504742007369 3.510272226919797e-07 -0.01739737733509573 -0.1157 0.5417842201357028 0.5417844593907097 3.6115069307340875e-07 -0.01741210832510655 -0.11580000000000001 0.5418182076499201 0.5418184405667594 3.7122622642549175e-07 -0.017426838535874397 -0.1159 0.541852191317334 0.5418524177285704 3.8125242185493846e-07 -0.0174415679667813 -0.116 0.5418861711368766 0.5418863908758387 3.9122788403345155e-07 -0.0174562966172094 -0.11610000000000001 0.5419201471074689 0.5419203600082729 4.011512235169157e-07 -0.017471024486541004 -0.1162 0.5419541192280204 0.5419543251255933 4.110210569396866e-07 -0.017485751574158537 -0.11630000000000001 0.5419880874974293 0.5419882862275323 4.2083600707010227e-07 -0.017500477879444566 -0.1164 0.542022051914583 0.5420222433138342 4.305947029492607e-07 -0.01751520340178179 -0.1165 0.5420560124783583 0.542056196384255 4.402957803628649e-07 -0.017529928140553076 -0.11660000000000001 0.54208996918762 0.5420901454385629 4.4993788178571137e-07 -0.01754465209514139 -0.1167 0.5421239220412225 0.5421240904765375 4.595196567702686e-07 -0.01755937526492984 -0.11680000000000001 0.5421578710380093 0.5421580314979705 4.69039762002188e-07 -0.017574097649301717 -0.1169 0.5421918161768127 0.542191968502665 4.784968613835705e-07 -0.017588819247640403 -0.117 0.5422257574564544 0.5422259014904357 4.878896265325672e-07 -0.017603540059329428 -0.11710000000000001 0.5422596948757454 0.542259830461109 4.972167367556235e-07 -0.01761826008375246 -0.1172 0.542293628433486 0.5422937554145228 5.064768792140129e-07 -0.01763297932029332 -0.11730000000000002 0.5423275581284661 0.5423276763505265 5.156687492291478e-07 -0.017647697768335968 -0.1174 0.5423614839594643 0.5423615932689803 5.247910505046249e-07 -0.017662415427264475 -0.1175 0.5423954059252496 0.5423955061697564 5.338424951262244e-07 -0.017677132296463085 -0.11760000000000001 0.5424293240245798 0.5424294150527381 5.428218038117105e-07 -0.017691848375316163 -0.1177 0.5424632382562027 0.5424633199178197 5.517277062438986e-07 -0.01770656366320821 -0.11780000000000002 0.5424971486188558 0.5424972207649067 5.605589409041212e-07 -0.017721278159523856 -0.1179 0.5425310551112665 0.5425311175939157 5.693142557106068e-07 -0.017735991863647924 -0.118 0.5425649577321517 0.542565010404774 5.779924079907239e-07 -0.017750704774965313 -0.11810000000000001 0.5425988564802187 0.5425988991974202 5.865921645087369e-07 -0.0177654168928611 -0.1182 0.542632751354164 0.5426327839718033 5.951123017433613e-07 -0.017780128216720474 -0.11830000000000002 0.5426666423526753 0.5426666647278833 6.035516062485868e-07 -0.017794838745928788 -0.1184 0.5427005294744291 0.5427005414656308 6.119088746259216e-07 -0.017809548479871536 -0.1185 0.5427344127180933 0.5427344141850271 6.201829135799031e-07 -0.01782425741793432 -0.11860000000000001 0.5427682920823256 0.542768282886064 6.283725406119878e-07 -0.017838965559502918 -0.1187 0.5428021675657739 0.5428021475687435 6.364765832989061e-07 -0.017853672903963235 -0.11880000000000002 0.5428360391670769 0.5428360082330776 6.444938806249301e-07 -0.017868379450701286 -0.1189 0.5428699068848639 0.5428698648790897 6.524232821769615e-07 -0.017883085199103272 -0.119 0.5429037707177545 0.5429037175068124 6.602636485886215e-07 -0.017897790148555522 -0.11910000000000001 0.5429376306643593 0.5429375661162886 6.680138520953616e-07 -0.0179124942984445 -0.1192 0.5429714867232797 0.5429714107075713 6.756727761736414e-07 -0.017927197648156798 -0.11930000000000002 0.5430053388931078 0.5430052512807233 6.832393160127737e-07 -0.01794190019707918 -0.1194 0.5430391871724269 0.5430390878358173 6.907123782651237e-07 -0.01795660194459851 -0.1195 0.5430730315598117 0.5430729203729355 6.980908820453102e-07 -0.017971302890101824 -0.11960000000000001 0.5431068720538272 0.5431067488921701 7.053737582363162e-07 -0.01798600303297629 -0.1197 0.5431407086530309 0.5431405733936225 7.125599499890889e-07 -0.01800070237260921 -0.11980000000000002 0.5431745413559704 0.5431743938774035 7.196484130278513e-07 -0.01801540090838805 -0.1199 0.5432083701611861 0.5432082103436335 7.266381154835688e-07 -0.01803009863970041 -0.12 0.5432421950672086 0.5432420227924417 7.335280383657938e-07 -0.01804479556593396 -0.12010000000000001 0.5432760160725616 0.5432758312239669 7.403171752295989e-07 -0.018059491686476647 -0.1202 0.5433098331757594 0.5433096356383567 7.470045330082442e-07 -0.01807418700071643 -0.12030000000000002 0.543343646375309 0.5433434360357674 7.535891317078658e-07 -0.018088881508041523 -0.12040000000000001 0.5433774556697091 0.5433772324163644 7.600700046572761e-07 -0.018103575207840172 -0.1205 0.5434112610574502 0.5434110247803219 7.66446198507964e-07 -0.01811826809950084 -0.12060000000000001 0.5434450625370156 0.5434448131278222 7.727167736781837e-07 -0.01813296018241209 -0.1207 0.5434788601068806 0.5434785974590566 7.788808044084661e-07 -0.01814765145596267 -0.1208 0.5435126537655133 0.5435123777742246 7.849373785395741e-07 -0.018162341919541466 -0.12090000000000001 0.5435464435113737 0.5435461540735338 7.908855980676144e-07 -0.018177031572537444 -0.121 0.5435802293429148 0.5435799263572 7.967245793105704e-07 -0.018191720414339748 -0.12110000000000001 0.5436140112585826 0.5436136946254472 8.024534525197247e-07 -0.01820640844433768 -0.1212 0.5436477892568157 0.5436474588785073 8.080713627123259e-07 -0.018221095661920695 -0.1213 0.5436815633360457 0.5436812191166196 8.135774693385223e-07 -0.018235782066478346 -0.12140000000000001 0.5437153334946977 0.5437149753400318 8.189709465034056e-07 -0.01825046765740036 -0.1215 0.5437490997311896 0.5437487275489986 8.242509831335454e-07 -0.018265152434076604 -0.12160000000000001 0.5437828620439331 0.5437824757437822 8.294167831435217e-07 -0.018279836395897087 -0.1217 0.5438166204313328 0.5438162199246526 8.34467565546948e-07 -0.018294519542251992 -0.1218 0.5438503748917873 0.5438499600918859 8.394025645119818e-07 -0.018309201872531496 -0.12190000000000001 0.5438841254236892 0.5438836962457667 8.44221029361325e-07 -0.01832388338612616 -0.122 0.5439178720254244 0.5439174283865857 8.489222247942685e-07 -0.01833856408242652 -0.12210000000000001 0.543951614695373 0.5439511565146404 8.535054314418034e-07 -0.018353243960823263 -0.1222 0.5439853534319095 0.5439848806302356 8.579699451449763e-07 -0.0183679230207073 -0.1223 0.544019088233402 0.5440186007336818 8.623150775100008e-07 -0.018382601261469612 -0.12240000000000001 0.5440528190982137 0.5440523168252966 8.66540156463369e-07 -0.01839727868250135 -0.1225 0.5440865460247015 0.5440860289054038 8.706445254746953e-07 -0.01841195528319381 -0.12260000000000001 0.544120269011218 0.5441197369743334 8.746275444448948e-07 -0.01842663106293846 -0.1227 0.5441539880561095 0.544153441032421 8.784885890400496e-07 -0.01844130602112684 -0.1228 0.5441877031577174 0.5441871410800088 8.822270514130537e-07 -0.01845598015715069 -0.12290000000000001 0.5442214143143786 0.5442208371174446 8.858423400370796e-07 -0.01847065347040187 -0.123 0.5442551215244251 0.5442545291450817 8.893338798721118e-07 -0.01848532596027244 -0.12310000000000001 0.5442888247861837 0.5442882171632787 8.927011123649464e-07 -0.018499997626154525 -0.1232 0.5443225240979771 0.5443219011724001 8.959434960598145e-07 -0.018514668467440414 -0.1233 0.5443562194581233 0.5443555811728157 8.990605057657142e-07 -0.018529338483522607 -0.12340000000000001 0.544389910864936 0.5443892571648996 9.020516331670336e-07 -0.018544007673793644 -0.1235 0.5444235983167248 0.5444229291490318 9.049163871011068e-07 -0.01855867603764629 -0.12360000000000002 0.5444572818117955 0.5444565971255966 9.076542930586129e-07 -0.01857334357447343 -0.1237 0.5444909613484494 0.5444902610949831 9.102648939607327e-07 -0.018588010283668074 -0.12380000000000001 0.544524636924985 0.544523921057585 9.127477498815928e-07 -0.018602676164623407 -0.12390000000000001 0.5445583085396961 0.5445575770138003 9.151024378817318e-07 -0.01861734121673272 -0.124 0.5445919761908737 0.5445912289640316 9.173285524521901e-07 -0.018632005439389483 -0.1241 0.5446256398768056 0.5446248769086854 9.194257055700206e-07 -0.018646668831987314 -0.1242 0.544659299595776 0.5446585208481723 9.213935265317552e-07 -0.018661331393919962 -0.12430000000000001 0.5446929553460663 0.5446921607829066 9.232316620089165e-07 -0.018675993124581316 -0.12440000000000001 0.5447266071259549 0.5447257967133062 9.249397766031286e-07 -0.018690654023365418 -0.1245 0.5447602549337177 0.544759428639793 9.265175522910063e-07 -0.018705314089666466 -0.1246 0.5447938987676278 0.544793056562792 9.279646889237547e-07 -0.018719973322878797 -0.1247 0.544827538625956 0.5448266804827315 9.292809040051253e-07 -0.01873463172239691 -0.12480000000000001 0.5448611745069702 0.5448603004000427 9.30465932857949e-07 -0.018749289287615375 -0.12490000000000001 0.5448948064089372 0.5448939163151604 9.315195286796474e-07 -0.018763946017929013 -0.125 0.5449284343301208 0.5449275282285215 9.32441462597744e-07 -0.018778601912732715 -0.12510000000000002 0.5449620582687835 0.544961136140566 9.332315237253752e-07 -0.018793256971421524 -0.1252 0.5449956782231857 0.5449947400517364 9.338895191612906e-07 -0.018807911193390675 -0.12530000000000002 0.5450292941915869 0.5450283399624773 9.344152741008749e-07 -0.01882256457803552 -0.1254 0.5450629061722445 0.5450619358732363 9.348086317251258e-07 -0.018837217124751584 -0.1255 0.5450965141634148 0.5450955277844618 9.350694533671877e-07 -0.018851868832934483 -0.12560000000000002 0.5451301181633531 0.5451291156966053 9.351976189009292e-07 -0.018866519701980045 -0.1257 0.5451637181703137 0.5451626996101195 9.35193025797254e-07 -0.018881169731284165 -0.12580000000000002 0.5451973141825501 0.545196279525459 9.350555898457458e-07 -0.018895818920242974 -0.1259 0.5452309061983152 0.54522985544308 9.347852452656902e-07 -0.018910467268252684 -0.126 0.5452644942158611 0.5452634273634394 9.343819448726087e-07 -0.018925114774709696 -0.12610000000000002 0.54529807823344 0.5452969952869957 9.33845659134569e-07 -0.018939761439010522 -0.1262 0.5453316582493033 0.5453305592142086 9.331763773934298e-07 -0.01895440726055185 -0.12630000000000002 0.5453652342617029 0.5453641191455381 9.323741070321745e-07 -0.01896905223873048 -0.1264 0.5453988062688908 0.5453976750814458 9.314388739745105e-07 -0.01898369637294342 -0.1265 0.5454323742691187 0.5454312270223929 9.303707222407809e-07 -0.01899833966258778 -0.12660000000000002 0.545465938260639 0.5454647749688417 9.291697142255195e-07 -0.019012982107060806 -0.1267 0.5454994982417047 0.5454983189212544 9.278359313080742e-07 -0.019027623705759913 -0.12680000000000002 0.5455330542105699 0.5455318588800936 9.263694724093163e-07 -0.019042264458082683 -0.1269 0.5455666061654886 0.5455653948458217 9.247704555459535e-07 -0.01905690436342682 -0.127 0.5456001541047164 0.5455989268189005 9.230390165537727e-07 -0.019071543421190124 -0.12710000000000002 0.5456336980265104 0.5456324547997924 9.211753100313302e-07 -0.0190861816307707 -0.1272 0.5456672379291284 0.5456659787889585 9.191795089513732e-07 -0.019100818991566668 -0.12730000000000002 0.5457007738108299 0.5456994987868593 9.1705180466084e-07 -0.01911545550297627 -0.1274 0.545734305669876 0.5457330147939548 9.147924063812596e-07 -0.01913009116439797 -0.1275 0.54576783350453 0.5457665268107041 9.124015424299969e-07 -0.019144725975230432 -0.12760000000000002 0.5458013573130563 0.5458000348375649 9.098794590545189e-07 -0.019159359934872375 -0.1277 0.5458348770937222 0.5458335388749934 9.072264209319947e-07 -0.019173993042722638 -0.12780000000000002 0.5458683928447967 0.545867038923445 9.044427108362285e-07 -0.019188625298180315 -0.1279 0.5459019045645515 0.5459005349833733 9.01528629970727e-07 -0.0192032567006446 -0.128 0.5459354122512605 0.54593402705523 8.984844980242102e-07 -0.01921788724951481 -0.1281 0.5459689159032011 0.545967515139465 8.953106522824328e-07 -0.01923251694419046 -0.1282 0.5460024155186523 0.5460009992365259 8.920074489604524e-07 -0.01924714578407116 -0.12830000000000003 0.546035911095897 0.5460344793468589 8.885752619258724e-07 -0.019261773768556725 -0.12840000000000001 0.5460694026332213 0.546067955470907 8.850144833094653e-07 -0.01927640089704706 -0.1285 0.5461028901289142 0.5461014276091113 8.813255233386386e-07 -0.01929102716894225 -0.1286 0.5461363735812683 0.5461348957619098 8.775088100598794e-07 -0.019305652583642592 -0.1287 0.5461698529885799 0.5461683599297379 8.735647900048882e-07 -0.01932027714054843 -0.1288 0.5462033283491491 0.5462018201130284 8.694939270803559e-07 -0.01933490083906029 -0.12890000000000001 0.5462367996612796 0.5462352763122104 8.65296703789209e-07 -0.019349523678578867 -0.129 0.5462702669232793 0.5462687285277099 8.609736197318085e-07 -0.01936414565850496 -0.1291 0.5463037301334605 0.5463021767599497 8.56525192993729e-07 -0.019378766778239593 -0.1292 0.5463371892901399 0.5463356210093491 8.519519587024682e-07 -0.019393387037183876 -0.1293 0.5463706443916384 0.5463690612763237 8.472544701931817e-07 -0.019408006434739108 -0.12940000000000002 0.5464040954362821 0.5464024975612849 8.424332981760152e-07 -0.019422624970306692 -0.1295 0.5464375424224013 0.5464359298646403 8.374890310136607e-07 -0.01943724264328822 -0.1296 0.5464709853483314 0.5464693581867935 8.324222746103338e-07 -0.019451859453085463 -0.1297 0.5465044242124131 0.5465027825281439 8.272336521897294e-07 -0.01946647539910029 -0.1298 0.5465378590129925 0.5465362028890861 8.219238042395105e-07 -0.01948109048073471 -0.12990000000000002 0.5465712897484205 0.5465696192700102 8.164933886223302e-07 -0.01949570469739094 -0.13 0.5466047164170542 0.5466030316713022 8.109430804648099e-07 -0.01951031804847127 -0.1301 0.546638139017256 0.5466364400933419 8.05273571879983e-07 -0.019524930533378233 -0.1302 0.5466715575473943 0.5466698445365052 7.994855720228067e-07 -0.01953954215151443 -0.1303 0.5467049720058436 0.5467032450011629 7.935798070901612e-07 -0.01955415290228268 -0.13040000000000002 0.546738382390984 0.5467366414876793 7.875570200988058e-07 -0.01956876278508589 -0.1305 0.5467717887012027 0.5467700339964147 7.814179711074232e-07 -0.01958337179932719 -0.1306 0.5468051909348925 0.546803422527723 7.75163436328441e-07 -0.019597979944409767 -0.1307 0.5468385890904532 0.5468368070819524 7.68794208905188e-07 -0.01961258721973705 -0.1308 0.5468719831662914 0.5468701876594455 7.623110984122938e-07 -0.019627193624712592 -0.13090000000000002 0.5469053731608199 0.5469035642605387 7.557149309111999e-07 -0.019641799158740054 -0.131 0.5469387590724593 0.5469369368855623 7.490065486726039e-07 -0.019656403821223307 -0.1311 0.5469721408996366 0.5469703055348402 7.421868099544149e-07 -0.019671007611566316 -0.1312 0.5470055186407867 0.54700367020869 7.352565896678875e-07 -0.01968561052917326 -0.1313 0.5470388922943514 0.5470370309074227 7.282167781563764e-07 -0.019700212573448447 -0.13140000000000002 0.54707226185878 0.5470703876313425 7.210682816949365e-07 -0.019714813743796283 -0.1315 0.54710562733253 0.5471037403807469 7.138120227401235e-07 -0.019729414039621414 -0.1316 0.5471389887140661 0.5471370891559266 7.064489388475259e-07 -0.019744013460328613 -0.1317 0.5471723460018612 0.5471704339571647 6.98979983504433e-07 -0.01975861200532275 -0.1318 0.5472056991943963 0.5472037747847374 6.91406125297167e-07 -0.019773209674008897 -0.13190000000000002 0.5472390482901603 0.5472371116389136 6.83728348327417e-07 -0.019787806465792278 -0.132 0.5472723932876509 0.5472704445199544 6.759476519069274e-07 -0.01980240238007825 -0.1321 0.5473057341853735 0.5473037734281134 6.680650503076979e-07 -0.019816997416272318 -0.1322 0.5473390709818432 0.5473370983636368 6.600815724844278e-07 -0.01983159157378019 -0.1323 0.5473724036755826 0.5473704193267622 6.519982623520715e-07 -0.01984618485200766 -0.13240000000000002 0.547405732265124 0.5474037363177198 6.438161784250163e-07 -0.0198607772503607 -0.1325 0.5474390567490083 0.5474370493367312 6.355363938448377e-07 -0.019875368768245454 -0.1326 0.5474723771257853 0.5474703583840104 6.271599960472329e-07 -0.019889959405068207 -0.1327 0.5475056933940146 0.5475036634597621 6.186880866787536e-07 -0.019904549160235367 -0.1328 0.5475390055522644 0.5475369645641833 6.101217815135396e-07 -0.019919138033153556 -0.13290000000000002 0.5475723135991131 0.5475702616974623 6.01462210092496e-07 -0.019933726023229514 -0.133 0.5476056175331482 0.5476035548597779 5.927105161118718e-07 -0.019948313129870117 -0.1331 0.5476389173529668 0.5476368440513006 5.838678565628364e-07 -0.01996289935248242 -0.1332 0.5476722130571761 0.5476701292721922 5.749354023421027e-07 -0.019977484690473633 -0.1333 0.5477055046443929 0.5477034105226046 5.659143371972153e-07 -0.019992069143251096 -0.13340000000000002 0.5477387921132447 0.5477366878026814 5.568058583649282e-07 -0.020006652710222332 -0.1335 0.5477720754623685 0.547769961112556 5.476111762381386e-07 -0.020021235390794995 -0.1336 0.5478053546904116 0.547803230452353 5.383315138107747e-07 -0.020035817184376897 -0.1337 0.547838629796032 0.547836495822187 5.289681069275964e-07 -0.020050398090376006 -0.1338 0.5478719007778979 0.5478697572221635 5.195222040899061e-07 -0.020064978108200477 -0.13390000000000002 0.5479051676346884 0.5479030146523773 5.099950661224817e-07 -0.020079557237258554 -0.134 0.5479384303650933 0.5479362681129145 5.003879659792876e-07 -0.02009413547695869 -0.1341 0.5479716889678125 0.5479695176038503 4.907021887712304e-07 -0.020108712826709448 -0.1342 0.5480049434415576 0.54800276312525 4.809390315163586e-07 -0.0201232892859196 -0.1343 0.5480381937850509 0.548036004677169 4.7109980302884047e-07 -0.020137864853998006 -0.13440000000000002 0.5480714399970261 0.5480692422596519 4.6118582361365235e-07 -0.02015243953035374 -0.1345 0.5481046820762279 0.5481024758727335 4.5119842484453443e-07 -0.02016701331439601 -0.1346 0.5481379200214122 0.5481357055164378 4.411389496472573e-07 -0.02018158620553416 -0.13470000000000001 0.5481711538313464 0.5481689311907779 4.3100875180002163e-07 -0.020196158203177703 -0.1348 0.5482043835048097 0.5482021528957568 4.2080919612774714e-07 -0.020210729306736324 -0.1349 0.5482376090405925 0.5482353706313665 4.1054165811349463e-07 -0.020225299515619834 -0.135 0.5482708304374971 0.548268584397588 4.0020752362091017e-07 -0.020239868829238238 -0.1351 0.5483040476943377 0.5483017941943913 3.898081887554472e-07 -0.020254437247001628 -0.13520000000000001 0.5483372608099402 0.5483350000217354 3.793450598643666e-07 -0.02026900476832033 -0.1353 0.5483704697831424 0.5483682018795683 3.688195530648919e-07 -0.02028357139260477 -0.1354 0.5484036746127944 0.5484013997678263 3.58233094382987e-07 -0.020298137119265553 -0.1355 0.5484368752977582 0.5484345936864352 3.475871192260005e-07 -0.02031270194771343 -0.1356 0.5484700718369084 0.5484677836353085 3.3688307249368776e-07 -0.020327265877359318 -0.13570000000000002 0.5485032642291315 0.5485009696143487 3.261224080786107e-07 -0.020341828907614285 -0.1358 0.5485364524733268 0.5485341516234465 3.1530658893552665e-07 -0.02035639103788955 -0.1359 0.5485696365684056 0.5485673296624813 3.044370867483215e-07 -0.020370952267596477 -0.136 0.5486028165132922 0.5486005037313203 2.935153818189873e-07 -0.020385512596146623 -0.1361 0.5486359923069233 0.5486336738298191 2.8254296274843327e-07 -0.020400072022951653 -0.13620000000000002 0.5486691639482483 0.5486668399578216 2.7152132631158565e-07 -0.020414630547423433 -0.1363 0.5487023314362295 0.5487000021151597 2.604519771937097e-07 -0.020429188168973968 -0.1364 0.548735494769842 0.5487331603016529 2.49336427976532e-07 -0.020443744887015405 -0.1365 0.5487686539480736 0.5487663145171093 2.3817619858312877e-07 -0.02045830070096007 -0.1366 0.5488018089699255 0.5487994647613242 2.269728163889484e-07 -0.020472855610220428 -0.13670000000000002 0.5488349598344116 0.548832611034081 2.157278159303777e-07 -0.02048740961420911 -0.1368 0.5488681065405592 0.5488657533351502 2.0444273866881968e-07 -0.020501962712338898 -0.1369 0.5489012490874084 0.5488988916642908 1.931191327408932e-07 -0.02051651490402273 -0.137 0.5489343874740129 0.5489320260212492 1.8175855273638852e-07 -0.020531066188673716 -0.1371 0.5489675216994399 0.5489651564057588 1.7036255967051162e-07 -0.0205456165657051 -0.13720000000000002 0.5490006517627691 0.548998282817541 1.5893272053979501e-07 -0.020560166034530303 -0.1373 0.5490337776630944 0.5490314052563042 1.474706081971977e-07 -0.02057471459456288 -0.1374 0.5490668993995227 0.5490645237217446 1.3597780119944947e-07 -0.02058926224521657 -0.1375 0.5491000169711749 0.5490976382135456 1.2445588348786174e-07 -0.02060380898590526 -0.1376 0.5491331303771851 0.5491307487313773 1.1290644427036645e-07 -0.020618354816042978 -0.13770000000000002 0.549166239616701 0.5491638552748977 1.0133107766069349e-07 -0.02063289973504393 -0.1378 0.5491993446888844 0.5491969578437519 8.973138263673741e-08 -0.020647443742322483 -0.1379 0.5492324455929103 0.5492300564375714 7.810896267973488e-08 -0.020661986837293127 -0.138 0.5492655423279674 0.5492631510559757 6.646542562854796e-08 -0.020676529019370546 -0.1381 0.5492986348932587 0.5492962416985705 5.4802383443741665e-08 -0.020691070287969557 -0.13820000000000002 0.549331723288001 0.5493293283649492 4.312145195778383e-08 -0.020705610642505166 -0.1383 0.5493648075114245 0.5493624110546917 3.142425067034771e-08 -0.02072015008239251 -0.1384 0.5493978875627737 0.5493954897673651 1.9712402533206275e-08 -0.020734688607046886 -0.1385 0.5494309634413068 0.5494285645025232 7.987533686554249e-09 -0.02074922621588376 -0.1386 0.5494640351462962 0.5494616352597065 -3.748726697117011e-09 -0.020763762908318745 -0.13870000000000002 0.549497102677028 0.5494947020384428 -1.5494746714861396e-08 -0.020778298683767626 -0.1388 0.5495301660328027 0.5495277648382462 -2.724889189460733e-08 -0.020792833541646336 -0.1389 0.5495632252129344 0.5495608236586177 -3.900952548051978e-08 -0.02080736748137095 -0.139 0.5495962802167519 0.5495938784990452 -5.07750086155799e-08 -0.020821900502357747 -0.1391 0.5496293310435976 0.5496269293590031 -6.25437005976736e-08 -0.02083643260402312 -0.13920000000000002 0.5496623776928282 0.5496599762379527 -7.431395909144461e-08 -0.020850963785783654 -0.1393 0.5496954201638147 0.549693019135342 -8.608414036812007e-08 -0.020865494047056066 -0.1394 0.5497284584559421 0.5497260580506053 -9.785259953189185e-08 -0.02088002338725724 -0.1395 0.5497614925686094 0.549759092983164 -1.096176907508517e-07 -0.020894551805804237 -0.1396 0.5497945225012301 0.5497921239324263 -1.21377767489661e-07 -0.02090907930211425 -0.13970000000000002 0.5498275482532317 0.5498251508977858 -1.3313118272725855e-07 -0.020923605875604642 -0.1398 0.5498605698240562 0.5498581738786242 -1.448762892118649e-07 -0.020938131525692946 -0.1399 0.5498935872131594 0.5498911928743089 -1.5661143966394508e-07 -0.020952656251796833 -0.14 0.5499266004200116 0.5499242078841945 -1.6833498703988647e-07 -0.02096718005333415 -0.1401 0.5499596094440974 0.5499572189076213 -1.8004528474363513e-07 -0.020981702929722904 -0.14020000000000002 0.5499926142849153 0.5499902259439172 -1.9174068684180146e-07 -0.020996224880381262 -0.1403 0.5500256149419784 0.5500232289923964 -2.0341954833080766e-07 -0.021010745904727523 -0.1404 0.5500586114148137 0.5500562280523593 -2.1508022536587124e-07 -0.021025266002180184 -0.1405 0.5500916037029626 0.550089223123093 -2.2672107544835507e-07 -0.021039785172157866 -0.1406 0.5501245918059807 0.5501222142038716 -2.3834045773107881e-07 -0.021054303414079392 -0.14070000000000002 0.5501575757234379 0.5501552012939558 -2.4993673316403564e-07 -0.021068820727363716 -0.1408 0.5501905554549182 0.5501881843925923 -2.6150826482052025e-07 -0.021083337111429956 -0.1409 0.5502235310000196 0.5502211634990152 -2.7305341805672345e-07 -0.021097852565697385 -0.141 0.5502565023583547 0.5502541386124447 -2.845705607545934e-07 -0.021112367089585454 -0.1411 0.5502894695295496 0.5502871097320879 -2.9605806360633036e-07 -0.021126880682513744 -0.14120000000000002 0.5503224325132453 0.5503200768571388 -3.075143002601033e-07 -0.021141393343902044 -0.1413 0.5503553913090965 0.5503530399867778 -3.1893764763923915e-07 -0.021155905073170254 -0.1414 0.5503883459167719 0.5503859991201718 -3.3032648610875626e-07 -0.021170415869738463 -0.1415 0.5504212963359546 0.5504189542564752 -3.4167919973904226e-07 -0.021184925733026924 -0.1416 0.5504542425663415 0.5504519053948289 -3.52994176514021e-07 -0.021199434662456027 -0.14170000000000002 0.5504871846076435 0.5504848525343603 -3.642698085809526e-07 -0.021213942657446354 -0.1418 0.5505201224595857 0.5505177956741836 -3.7550449254186713e-07 -0.02122844971741861 -0.1419 0.5505530561219067 0.5505507348134 -3.866966294674423e-07 -0.021242955841793684 -0.142 0.5505859855943598 0.5505836699510979 -3.978446254382373e-07 -0.021257461029992625 -0.1421 0.5506189108767114 0.5506166010863524 -4.089468914753036e-07 -0.02127196528143664 -0.14220000000000002 0.5506518319687422 0.5506495282182257 -4.2000184398427454e-07 -0.02128646859554711 -0.1423 0.5506847488702463 0.5506824513457667 -4.3100790490802066e-07 -0.021300970971745534 -0.1424 0.5507176615810323 0.5507153704680119 -4.4196350185155e-07 -0.02131547240945364 -0.1425 0.5507505701009218 0.5507482855839845 -4.5286706852609715e-07 -0.02132997290809326 -0.1426 0.5507834744297503 0.5507811966926947 -4.6371704487402354e-07 -0.021344472467086418 -0.14270000000000002 0.5508163745673671 0.5508141037931402 -4.7451187709657283e-07 -0.021358971085855282 -0.1428 0.5508492705136351 0.5508470068843062 -4.852500180840824e-07 -0.02137346876382221 -0.1429 0.5508821622684303 0.5508799059651646 -4.959299277629281e-07 -0.021387965500409695 -0.143 0.5509150498316427 0.5509128010346749 -5.065500731649131e-07 -0.02140246129504039 -0.1431 0.5509479332031753 0.5509456920917842 -5.17108928482779e-07 -0.02141695614713712 -0.14320000000000002 0.5509808123829447 0.5509785791354266 -5.276049755142953e-07 -0.02143145005612287 -0.1433 0.5510136873708809 0.5510114621645242 -5.380367038287925e-07 -0.021445943021420784 -0.1434 0.5510465581669266 0.5510443411779866 -5.484026111002294e-07 -0.021460435042454193 -0.1435 0.5510794247710387 0.5510772161747108 -5.587012031349481e-07 -0.021474926118646556 -0.1436 0.5511122871831862 0.5511100871535816 -5.68930994176986e-07 -0.02148941624942151 -0.14370000000000002 0.5511451454033517 0.5511429541134717 -5.790905069635865e-07 -0.021503905434202858 -0.1438 0.5511779994315307 0.5511758170532415 -5.891782733913331e-07 -0.021518393672414548 -0.1439 0.5512108492677312 0.5512086759717394 -5.991928340998154e-07 -0.021532880963480702 -0.144 0.551243694911975 0.5512415308678016 -6.091327392765411e-07 -0.02154736730682562 -0.1441 0.5512765363642957 0.5512743817402527 -6.189965485181581e-07 -0.021561852701873736 -0.14420000000000002 0.5513093736247401 0.551307228587905 -6.287828309969878e-07 -0.02157633714804967 -0.1443 0.5513422066933676 0.5513400714095595 -6.384901660994036e-07 -0.0215908206447782 -0.1444 0.5513750355702499 0.5513729102040051 -6.481171430094967e-07 -0.021605303191484262 -0.1445 0.5514078602554714 0.5514057449700192 -6.576623614584776e-07 -0.021619784787592952 -0.1446 0.5514406807491286 0.5514385757063677 -6.671244316969194e-07 -0.021634265432529533 -0.14470000000000002 0.5514734970513303 0.5514714024118048 -6.765019746612921e-07 -0.021648745125719418 -0.1448 0.551506309162198 0.5515042250850738 -6.857936222237626e-07 -0.021663223866588206 -0.1449 0.551539117081865 0.5515370437249061 -6.94998017608528e-07 -0.021677701654561662 -0.145 0.5515719208104766 0.5515698583300225 -7.041138152252824e-07 -0.02169217848906571 -0.1451 0.5516047203481899 0.551602668899132 -7.131396810855506e-07 -0.02170665436952642 -0.14520000000000002 0.5516375156951742 0.5516354754309336 -7.22074292802688e-07 -0.02172112929537004 -0.1453 0.5516703068516101 0.5516682779241142 -7.309163401192365e-07 -0.021735603266022953 -0.1454 0.5517030938176902 0.5517010763773506 -7.396645248514133e-07 -0.021750076280911745 -0.1455 0.5517358765936189 0.5517338707893086 -7.483175613332005e-07 -0.021764548339463164 -0.1456 0.5517686551796115 0.5517666611586438 -7.568741761110331e-07 -0.021779019441104108 -0.14570000000000002 0.5518014295758945 0.5517994474840009 -7.653331086654447e-07 -0.021793489585261644 -0.1458 0.5518341997827063 0.5518322297640137 -7.736931113000445e-07 -0.021807958771362965 -0.1459 0.5518669658002963 0.5518650079973068 -7.819529494190736e-07 -0.021822426998835506 -0.146 0.5518997276289246 0.5518977821824937 -7.901114019159827e-07 -0.021836894267106815 -0.1461 0.5519324852688627 0.5519305523181782 -7.981672608403656e-07 -0.021851360575604595 -0.14620000000000002 0.5519652387203924 0.5519633184029541 -8.061193320640925e-07 -0.02186582592375676 -0.1463 0.5519979879838065 0.551996080435405 -8.13966435170288e-07 -0.021880290310991337 -0.1464 0.5520307330594086 0.5520288384141052 -8.217074039529315e-07 -0.021894753736736564 -0.1465 0.5520634739475124 0.5520615923376186 -8.293410861115458e-07 -0.021909216200420776 -0.1466 0.5520962106484422 0.5520943422045006 -8.368663439450863e-07 -0.02192367770147259 -0.14670000000000002 0.5521289431625325 0.5521270880132962 -8.442820541854079e-07 -0.021938138239320656 -0.1468 0.5521616714901276 0.5521598297625417 -8.515871081637982e-07 -0.021952597813393846 -0.1469 0.5521943956315826 0.552192567450764 -8.587804123660892e-07 -0.021967056423121217 -0.147 0.5522271155872618 0.5522253010764809 -8.658608880995899e-07 -0.021981514067932008 -0.14709999999999998 0.5522598313575395 0.5522580306382014 -8.728274717983986e-07 -0.021995970747255563 -0.14720000000000003 0.5522925429427997 0.5522907561344256 -8.796791154952466e-07 -0.022010426460521388 -0.14730000000000001 0.5523252503434357 0.5523234775636449 -8.864147865161875e-07 -0.022024881207159203 -0.1474 0.5523579535598503 0.552356194924342 -8.930334681744867e-07 -0.02203933498659888 -0.1475 0.5523906525924558 0.5523889082149916 -8.995341594375539e-07 -0.022053787798270465 -0.14759999999999998 0.5524233474416734 0.5524216174340597 -9.059158750379659e-07 -0.022068239641604134 -0.14770000000000003 0.5524560381079333 0.5524543225800043 -9.121776462506226e-07 -0.02208269051603027 -0.14780000000000001 0.5524887245916745 0.5524870236512753 -9.183185205041688e-07 -0.022097140420979378 -0.1479 0.5525214068933452 0.5525197206463147 -9.24337561547528e-07 -0.02211158935588218 -0.148 0.5525540850134014 0.5525524135635564 -9.302338500050134e-07 -0.022126037320169517 -0.14809999999999998 0.5525867589523082 0.5525851024014274 -9.360064829877501e-07 -0.02214048431327241 -0.14820000000000003 0.5526194287105388 0.5526177871583466 -9.416545744822535e-07 -0.02215493033462206 -0.14830000000000002 0.5526520942885744 0.5526504678327262 -9.471772558500291e-07 -0.022169375383649832 -0.1484 0.5526847556869047 0.5526831444229701 -9.525736752724612e-07 -0.022183819459787257 -0.1485 0.552717412906027 0.5527158169274761 -9.578429980838798e-07 -0.022198262562466015 -0.14859999999999998 0.5527500659464464 0.5527484853446347 -9.629844073821836e-07 -0.022212704691117982 -0.14870000000000003 0.5527827148086754 0.5527811496728299 -9.679971036957724e-07 -0.02222714584517517 -0.14880000000000002 0.5528153594932343 0.5528138099104387 -9.72880305427637e-07 -0.022241586024069768 -0.1489 0.5528480000006508 0.5528464660558314 -9.776332484667805e-07 -0.022256025227234147 -0.149 0.5528806363314592 0.5528791181073727 -9.822551867433305e-07 -0.022270463454100817 -0.14909999999999998 0.5529132684862013 0.5529117660634206 -9.867453922285385e-07 -0.022284900704102453 -0.14920000000000003 0.5529458964654257 0.5529444099223269 -9.911031551013139e-07 -0.022299336976671937 -0.14930000000000002 0.5529785202696879 0.5529770496824379 -9.95327784025779e-07 -0.022313772271242288 -0.1494 0.5530111398995494 0.553009685342094 -9.994186056516696e-07 -0.02232820658724673 -0.1495 0.5530437553555787 0.5530423168996302 -1.0033749652249568e-06 -0.02234263992411859 -0.14959999999999998 0.5530763666383502 0.5530749443533759 -1.0071962269209145e-06 -0.022357072281291402 -0.14970000000000003 0.5531089737484449 0.5531075677016548 -1.0108817732334963e-06 -0.02237150365819887 -0.14980000000000002 0.5531415766864489 0.5531401869427862 -1.0144310060300477e-06 -0.022385934054274827 -0.1499 0.5531741754529549 0.5531728020750839 -1.0178433456631275e-06 -0.022400363468953324 -0.15 0.5532067700485611 0.5532054130968573 -1.0211182312480638e-06 -0.022414791901668576 -0.15009999999999998 0.553239360473871 0.5532380200064109 -1.024255121551132e-06 -0.02242921935185493 -0.15020000000000003 0.553271946729493 0.5532706228020446 -1.0272534944899547e-06 -0.02244364581894692 -0.15030000000000002 0.5533045288160414 0.5533032214820544 -1.0301128469669685e-06 -0.022458071302379236 -0.1504 0.5533371067341353 0.5533358160447316 -1.0328326953690237e-06 -0.02247249580158675 -0.1505 0.5533696804843984 0.5533684064883637 -1.035412576011474e-06 -0.022486919316004512 -0.15059999999999998 0.5534022500674594 0.5534009928112344 -1.0378520442499983e-06 -0.022501341845067687 -0.15070000000000003 0.5534348154839512 0.5534335750116242 -1.0401506748136669e-06 -0.022515763388211707 -0.15080000000000002 0.5534673767345113 0.553466153087809 -1.0423080630261872e-06 -0.022530183944872086 -0.1509 0.5534999338197811 0.553498727038062 -1.0443238231960805e-06 -0.02254460351448448 -0.151 0.5535324867404067 0.5535312968606535 -1.0461975900599718e-06 -0.022559022096484894 -0.15109999999999998 0.5535650354970367 0.55356386255385 -1.0479290177833889e-06 -0.022573439690309234 -0.15120000000000003 0.5535975800903248 0.553596424115916 -1.0495177807934297e-06 -0.02258785629539379 -0.15130000000000002 0.5536301205209273 0.5536289815451125 -1.050963573556718e-06 -0.02260227191117492 -0.1514 0.5536626567895048 0.5536615348396986 -1.0522661103018471e-06 -0.02261668653708919 -0.1515 0.5536951888967199 0.5536940839979307 -1.0534251260185812e-06 -0.0226311001725733 -0.15159999999999998 0.5537277168432391 0.5537266290180634 -1.0544403754031428e-06 -0.022645512817064173 -0.15170000000000003 0.5537602406297311 0.5537591698983486 -1.0553116336908808e-06 -0.022659924469998833 -0.15180000000000002 0.5537927602568679 0.553791706637037 -1.0560386963787138e-06 -0.02267433513081453 -0.1519 0.5538252757253236 0.5538242392323774 -1.0566213792251311e-06 -0.022688744798948675 -0.152 0.5538577870357746 0.553856767682617 -1.0570595184722364e-06 -0.022703153473838777 -0.15209999999999999 0.5538902941888999 0.5538892919860019 -1.0573529707347262e-06 -0.022717561154922628 -0.15220000000000003 0.55392279718538 0.5539218121407768 -1.0575016131109116e-06 -0.022731967841638098 -0.15230000000000002 0.553955296025897 0.5539543281451857 -1.0575053435712967e-06 -0.022746373533423254 -0.1524 0.5539877907111355 0.5539868399974716 -1.0573640799593775e-06 -0.022760778229716335 -0.1525 0.5540202812417809 0.5540193476958766 -1.0570777612128879e-06 -0.02277518192995577 -0.15259999999999999 0.5540527676185205 0.554051851238643 -1.0566463468086873e-06 -0.02278958463358018 -0.15270000000000003 0.5540852498420418 0.5540843506240123 -1.056069816596228e-06 -0.022803986340028243 -0.15280000000000002 0.554117727913034 0.5541168458502259 -1.0553481711861323e-06 -0.022818387048738925 -0.1529 0.5541502018321867 0.5541493369155256 -1.0544814318946827e-06 -0.022832786759151298 -0.153 0.5541826716001901 0.5541818238181531 -1.0534696407438204e-06 -0.02284718547070462 -0.15309999999999999 0.5542151372177351 0.5542143065563505 -1.0523128603501242e-06 -0.022861583182838315 -0.15320000000000003 0.5542475986855128 0.5542467851283608 -1.0510111740358319e-06 -0.022875979894992023 -0.15330000000000002 0.554280056004214 0.5542792595324275 -1.0495646857733298e-06 -0.022890375606605475 -0.1534 0.55431250917453 0.5543117297667951 -1.0479735204071972e-06 -0.022904770317118614 -0.1535 0.5543449581971515 0.5543441958297091 -1.0462378231546055e-06 -0.022919164025971574 -0.15360000000000001 0.5543774030727682 0.5543766577194164 -1.044357759993897e-06 -0.0229335567326046 -0.1537 0.5544098438020701 0.5544091154341653 -1.0423335178866289e-06 -0.02294794843645819 -0.15380000000000002 0.5544422803857463 0.554441568972206 -1.04016530411144e-06 -0.02296233913697296 -0.1539 0.5544747128244842 0.55447401833179 -1.0378533468746731e-06 -0.02297672883358967 -0.154 0.5545071411189704 0.5545064635111712 -1.0353978948107745e-06 -0.022991117525749297 -0.15410000000000001 0.5545395652698907 0.5545389045086053 -1.0327992171488276e-06 -0.023005505212892987 -0.1542 0.5545719852779286 0.5545713413223506 -1.0300576038790865e-06 -0.023019891894462047 -0.15430000000000002 0.5546044011437665 0.5546037739506682 -1.0271733655864423e-06 -0.02303427756989795 -0.1544 0.5546368128680845 0.554636202391821 -1.0241468335614456e-06 -0.023048662238642333 -0.1545 0.5546692204515612 0.5546686266440757 -1.0209783588011057e-06 -0.02306304590013704 -0.15460000000000002 0.5547016238948724 0.5547010467057015 -1.0176683135076914e-06 -0.023077428553824005 -0.1547 0.5547340231986921 0.5547334625749709 -1.0142170902005532e-06 -0.023091810199145458 -0.15480000000000002 0.5547664183636912 0.5547658742501597 -1.010625101827145e-06 -0.023106190835543657 -0.1549 0.554798809390538 0.5547982817295473 -1.0068927816520024e-06 -0.023120570462461132 -0.155 0.5548311962798986 0.5548306850114171 -1.003020582979186e-06 -0.023134949079340595 -0.15510000000000002 0.5548635790324352 0.5548630840940562 -9.990089798739277e-07 -0.023149326685624895 -0.1552 0.554895957648807 0.5548954789757555 -9.948584662744508e-07 -0.02316370328075698 -0.15530000000000002 0.55492833212967 0.5549278696548106 -9.905695563805494e-07 -0.023178078864180097 -0.1554 0.5549607024756763 0.5549602561295213 -9.861427843205206e-07 -0.023192453435337598 -0.1555 0.5549930686874743 0.5549926383981919 -9.815787044842317e-07 -0.02320682699367298 -0.15560000000000002 0.555025430765709 0.5550250164591315 -9.768778912455645e-07 -0.023221199538629996 -0.1557 0.5550577887110205 0.5550573903106544 -9.720409387403706e-07 -0.023235571069652496 -0.15580000000000002 0.5550901425240451 0.5550897599510795 -9.67068461033005e-07 -0.02324994158618455 -0.1559 0.5551224922054147 0.5551221253787315 -9.619610917277477e-07 -0.023264311087670388 -0.156 0.5551548377557561 0.55515448659194 -9.567194844684046e-07 -0.023278679573554346 -0.15610000000000002 0.555187179175692 0.5551868435890408 -9.513443124387067e-07 -0.023293047043281043 -0.1562 0.5552195164658399 0.555219196368375 -9.458362681402654e-07 -0.023307413496295195 -0.15630000000000002 0.5552518496268121 0.55525154492829 -9.401960637256401e-07 -0.023321778932041744 -0.1564 0.5552841786592154 0.5552838892671386 -9.344244305542482e-07 -0.023336143349965713 -0.1565 0.5553165035636517 0.5553162293832808 -9.2852211941441e-07 -0.023350506749512435 -0.15660000000000002 0.5553488243407169 0.5553485652750827 -9.22489900190282e-07 -0.023364869130127267 -0.1567 0.5553811409910012 0.5553808969409166 -9.163285617508343e-07 -0.023379230491255842 -0.15680000000000002 0.5554134535150889 0.5554132243791621 -9.100389121718955e-07 -0.023393590832343908 -0.1569 0.5554457619135582 0.5554455475882054 -9.036217783475742e-07 -0.023407950152837448 -0.157 0.555478066186981 0.5554778665664399 -8.970780059347483e-07 -0.023422308452182572 -0.15710000000000002 0.5555103663359229 0.5555101813122665 -8.90408459075509e-07 -0.02343666572982553 -0.1572 0.5555426623609429 0.555542491824093 -8.836140204526721e-07 -0.02345102198521284 -0.15730000000000002 0.555574954262593 0.5555747981003353 -8.76695591733867e-07 -0.023465377217791124 -0.1574 0.5556072420414186 0.5556071001394165 -8.69654092516825e-07 -0.023479731427007183 -0.1575 0.555639525697958 0.555639397939768 -8.62490460606935e-07 -0.023494084612308022 -0.15760000000000002 0.5556718052327421 0.5556716914998292 -8.552056521005102e-07 -0.02350843677314078 -0.1577 0.5557040806462947 0.5557039808180478 -8.478006407741656e-07 -0.023522787908952826 -0.15780000000000002 0.5557363519391318 0.5557362658928793 -8.402764184178846e-07 -0.023537138019191616 -0.1579 0.5557686191117619 0.5557685467227882 -8.326339946962413e-07 -0.02355148710330486 -0.158 0.5558008821646855 0.5558008233062475 -8.248743966488004e-07 -0.0235658351607404 -0.15810000000000002 0.5558331410983953 0.5558330956417392 -8.169986686901165e-07 -0.023580182190946257 -0.1582 0.5558653959133759 0.5558653637277542 -8.090078730538242e-07 -0.023594528193370663 -0.15830000000000002 0.5558976466101033 0.5558976275627924 -8.009030885436363e-07 -0.023608873167461977 -0.1584 0.5559298931890452 0.5559298871453628 -7.926854113937676e-07 -0.023623217112668717 -0.1585 0.5559621356506609 0.5559621424739845 -7.843559546583112e-07 -0.023637560028439645 -0.15860000000000002 0.5559943739954009 0.5559943935471852 -7.759158479336836e-07 -0.02365190191422363 -0.1587 0.5560266082237066 0.5560266403635032 -7.673662376084245e-07 -0.023666242769469763 -0.15880000000000002 0.5560588383360108 0.556058882921486 -7.5870828677993e-07 -0.02368058259362727 -0.1589 0.5560910643327368 0.5560911212196914 -7.499431743107632e-07 -0.02369492138614558 -0.159 0.5561232862142984 0.5561233552566872 -7.41072095494788e-07 -0.023709259146474287 -0.15910000000000002 0.5561555039811007 0.5561555850310518 -7.320962614743021e-07 -0.023723595874063155 -0.1592 0.5561877176335387 0.5561878105413736 -7.230168993788144e-07 -0.023737931568362146 -0.15930000000000002 0.5562199271719978 0.5562200317862516 -7.138352519087121e-07 -0.023752266228821373 -0.15940000000000001 0.5562521325968532 0.5562522487642957 -7.045525771687267e-07 -0.023766599854891112 -0.1595 0.5562843339084705 0.5562844614741265 -6.951701487512008e-07 -0.023780932446021825 -0.15960000000000002 0.5563165311072054 0.5563166699143756 -6.856892552642435e-07 -0.023795264001664183 -0.1597 0.5563487241934026 0.5563488740836855 -6.761112002762193e-07 -0.023809594521268983 -0.1598 0.5563809131673972 0.5563810739807105 -6.664373022047254e-07 -0.023823924004287223 -0.15990000000000001 0.5564130980295133 0.5564132696041154 -6.566688942333254e-07 -0.023838252450170083 -0.16 0.5564452787800647 0.5564454609525771 -6.468073236731708e-07 -0.023852579858368896 -0.16010000000000002 0.5564774554193538 0.5564776480247838 -6.36853952240557e-07 -0.02386690622833515 -0.1602 0.5565096279476727 0.5565098308194355 -6.268101557238559e-07 -0.02388123155952057 -0.1603 0.5565417963653022 0.5565420093352441 -6.166773238724943e-07 -0.02389555585137701 -0.16040000000000001 0.5565739606725124 0.5565741835709335 -6.06456859897353e-07 -0.023909879103356537 -0.1605 0.5566061208695617 0.5566063535252396 -5.961501808315894e-07 -0.023924201314911353 -0.16060000000000002 0.5566382769566971 0.5566385191969104 -5.85758716864504e-07 -0.023938522485493854 -0.1607 0.5566704289341544 0.5566706805847066 -5.752839111750063e-07 -0.02395284261455661 -0.1608 0.5567025768021575 0.5567028376874008 -5.647272200703934e-07 -0.023967161701552372 -0.16090000000000002 0.5567347205609189 0.5567349905037787 -5.540901124589936e-07 -0.02398147974593405 -0.161 0.5567668602106388 0.5567671390326384 -5.433740697668998e-07 -0.023995796747154755 -0.16110000000000002 0.5567989957515058 0.5567992832727905 -5.325805857436805e-07 -0.024010112704667755 -0.1612 0.5568311271836969 0.5568314232230591 -5.217111662680907e-07 -0.024024427617926516 -0.1613 0.5568632545073757 0.556863558882281 -5.107673290427606e-07 -0.024038741486384657 -0.16140000000000002 0.5568953777226947 0.5568956902493059 -4.997506035109289e-07 -0.024053054309495947 -0.1615 0.5569274968297933 0.5569278173229969 -4.886625306621539e-07 -0.024067366086714406 -0.16160000000000002 0.5569596118287988 0.5569599401022305 -4.775046626159796e-07 -0.02408167681749418 -0.1617 0.5569917227198259 0.5569920585858964 -4.662785626219357e-07 -0.02409598650128959 -0.1618 0.5570238295029765 0.5570241727728978 -4.54985804726471e-07 -0.02411029513755515 -0.16190000000000002 0.5570559321783398 0.5570562826621518 -4.436279735786641e-07 -0.024124602725745542 -0.162 0.5570880307459921 0.5570883882525888 -4.322066643330791e-07 -0.02413890926531563 -0.16210000000000002 0.557120125205997 0.5571204895431531 -4.2072348217792044e-07 -0.024153214755720444 -0.1622 0.5571522155584046 0.5571525865328031 -4.0918004221013327e-07 -0.02416751919641521 -0.1623 0.5571843018032524 0.5571846792205111 -3.9757796943540313e-07 -0.02418182258685532 -0.16240000000000002 0.5572163839405639 0.5572167676052628 -3.859188981991668e-07 -0.02419612492649633 -0.1625 0.5572484619703504 0.5572488516860592 -3.7420447220049e-07 -0.02421042621479399 -0.16260000000000002 0.5572805358926088 0.5572809314619147 -3.624363441590006e-07 -0.024224726451204236 -0.1627 0.557312605707323 0.5573130069318581 -3.506161755234549e-07 -0.024239025635183153 -0.1628 0.5573446714144632 0.557345078094933 -3.387456363884711e-07 -0.02425332376618702 -0.16290000000000002 0.557376733013986 0.5573771449501971 -3.2682640523085116e-07 -0.02426762084367229 -0.163 0.5574087905058346 0.5574092074967223 -3.1486016849324727e-07 -0.024281916867095594 -0.16310000000000002 0.5574408438899381 0.5574412657335959 -3.0284862055640627e-07 -0.024296211835913743 -0.1632 0.5574728931662116 0.557473319659919 -2.9079346344773604e-07 -0.024310505749583714 -0.1633 0.5575049383345567 0.5575053692748084 -2.7869640653599426e-07 -0.02432479860756269 -0.16340000000000002 0.5575369793948606 0.5575374145773951 -2.665591664063882e-07 -0.024339090409307998 -0.1635 0.5575690163469966 0.5575694555668252 -2.543834664858746e-07 -0.02435338115427715 -0.16360000000000002 0.5576010491908244 0.5576014922422597 -2.4217103682111496e-07 -0.02436767084192787 -0.1637 0.5576330779261889 0.5576335246028745 -2.2992361392581984e-07 -0.02438195947171801 -0.1638 0.5576651025529207 0.5576655526478604 -2.17642940517071e-07 -0.024396247043105626 -0.16390000000000002 0.5576971230708364 0.557697576376424 -2.0533076516143778e-07 -0.024410533555548956 -0.164 0.5577291394797383 0.5577295957877866 -1.9298884214313805e-07 -0.0244248190085064 -0.16410000000000002 0.5577611517794142 0.5577616108811845 -1.8061893116566585e-07 -0.024439103401436554 -0.1642 0.5577931599696373 0.5577936216558698 -1.6822279708811338e-07 -0.02445338673379815 -0.1643 0.5578251640501666 0.5578256281111097 -1.5580220966843195e-07 -0.024467669005050183 -0.16440000000000002 0.5578571640207463 0.5578576302461865 -1.433589433830207e-07 -0.024481950214651743 -0.1645 0.5578891598811059 0.5578896280603987 -1.3089477712835418e-07 -0.02449623036206213 -0.16460000000000002 0.5579211516309608 0.5579216215530592 -1.1841149391567107e-07 -0.024510509446740828 -0.1647 0.5579531392700111 0.5579536107234977 -1.0591088071831845e-07 -0.024524787468147492 -0.1648 0.5579851227979425 0.5579855955710584 -9.339472810745986e-08 -0.02453906442574197 -0.16490000000000002 0.558017102214426 0.5580175760951012 -8.086483008901135e-08 -0.02455334031898425 -0.165 0.5580490775191179 0.558049552295002 -6.832298380179957e-08 -0.02456761514733454 -0.16510000000000002 0.5580810487116592 0.5580815241701521 -5.577098926429214e-08 -0.02458188891025321 -0.1652 0.5581130157916767 0.5581134917199587 -4.3210649117858546e-08 -0.024596161607200823 -0.1653 0.5581449787587817 0.5581454549438446 -3.06437683821742e-08 -0.024610433237638087 -0.16540000000000002 0.5581769376125709 0.5581774138412482 -1.8072154159883697e-08 -0.024624703801025924 -0.1655 0.5582088923526262 0.5582093684116237 -5.497615418242549e-09 -0.024638973296825406 -0.16560000000000002 0.5582408429785143 0.5582413186544413 7.078037296028017e-09 -0.02465324172449782 -0.16570000000000001 0.558272789489787 0.5582732645691866 1.9652992113913803e-08 -0.024667509083504596 -0.1658 0.5583047318859817 0.5583052061553614 3.222543609737727e-08 -0.024681775373307378 -0.1659 0.5583366701666196 0.558337143412483 4.479355550715547e-08 -0.024696040593367944 -0.166 0.5583686043312078 0.5583690763400847 5.735553607055799e-08 -0.024710304743148302 -0.16610000000000003 0.5584005343792388 0.5584010049377157 6.990956322519559e-08 -0.024724567822110615 -0.16620000000000001 0.5584324603101886 0.5584329292049411 8.245382242602628e-08 -0.0247388298297172 -0.1663 0.5584643821235196 0.5584648491413418 9.498649932923597e-08 -0.024753090765430613 -0.1664 0.5584962998186783 0.558496764746514 1.0750578013224432e-07 -0.02476735062871354 -0.1665 0.5585282133950966 0.5585286760200707 1.2000985180615764e-07 -0.024781609419028846 -0.16660000000000003 0.5585601228521915 0.5585605829616401 1.324969023386302e-07 -0.02479586713583963 -0.16670000000000001 0.5585920281893645 0.5585924855708666 1.4496512099754222e-07 -0.024810123778609125 -0.1668 0.558623929406002 0.5586243838474104 1.574126987161084e-07 -0.024824379346800717 -0.1669 0.5586558265014763 0.5586562777909473 1.6983782814838921e-07 -0.024838633839878055 -0.167 0.5586877194751436 0.5586881674011691 1.8223870407868548e-07 -0.024852887257304897 -0.16710000000000003 0.5587196083263459 0.5587200526777836 1.946135236366442e-07 -0.024867139598545217 -0.16720000000000002 0.5587514930544095 0.558751933620514 2.0696048659563093e-07 -0.024881390863063135 -0.1673 0.5587833736586465 0.5587838102290998 2.1927779560171334e-07 -0.024895641050323002 -0.1674 0.5588152501383538 0.5588156825032957 2.31563656444278e-07 -0.024909890159789297 -0.1675 0.5588471224928132 0.5588475504428725 2.438162782503195e-07 -0.02492413819092672 -0.16760000000000003 0.5588789907212918 0.5588794140476168 2.5603387389383503e-07 -0.02493838514320014 -0.16770000000000002 0.5589108548230418 0.5589112733173306 2.682146601484803e-07 -0.024952631016074596 -0.1678 0.5589427147973003 0.5589431282518318 2.8035685803451393e-07 -0.024966875809015302 -0.1679 0.5589745706432901 0.5589749788509537 2.9245869294369786e-07 -0.02498111952148768 -0.168 0.5590064223602189 0.5590068251145455 3.0451839501399736e-07 -0.0249953621529573 -0.16810000000000003 0.5590382699472799 0.5590386670424717 3.165341992961146e-07 -0.025009603702889946 -0.16820000000000002 0.5590701134036511 0.5590705046346127 3.285043462253334e-07 -0.025023844170751583 -0.1683 0.5591019527284964 0.5591023378908637 3.404270816631527e-07 -0.0250380835560083 -0.1684 0.5591337879209648 0.5591341668111361 3.52300657119331e-07 -0.025052321858126444 -0.1685 0.5591656189801909 0.5591659913953564 3.64123330237609e-07 -0.0250665590765725 -0.16860000000000003 0.5591974459052943 0.5591978116434664 3.758933648650986e-07 -0.025080795210813134 -0.16870000000000002 0.5592292686953806 0.5592296275554233 3.876090314269831e-07 -0.025095030260315204 -0.1688 0.5592610873495409 0.5592614391311994 3.992686070930507e-07 -0.025109264224545732 -0.1689 0.559292901866852 0.5592932463707825 4.108703760691279e-07 -0.02512349710297195 -0.169 0.559324712246376 0.5593250492741751 4.2241262987463557e-07 -0.025137728895061263 -0.16910000000000003 0.5593565184871611 0.5593568478413954 4.338936675507554e-07 -0.025151959600281243 -0.16920000000000002 0.5593883205882412 0.5593886420724762 4.453117959102304e-07 -0.025166189218099662 -0.1693 0.5594201185486359 0.5594204319674655 4.566653299120649e-07 -0.025180417747984452 -0.1694 0.559451912367351 0.5594522175264258 4.679525926476469e-07 -0.025194645189403737 -0.1695 0.5594837020433783 0.5594839987494351 4.791719159513708e-07 -0.025208871541825852 -0.16960000000000003 0.5595154875756949 0.5595157756365855 4.903216402618593e-07 -0.025223096804719243 -0.16970000000000002 0.5595472689632655 0.5595475481879844 5.01400115260342e-07 -0.025237320977552626 -0.1698 0.5595790462050393 0.5595793164037531 5.124056997596327e-07 -0.02525154405979481 -0.1699 0.5596108192999532 0.5596110802840285 5.233367622314855e-07 -0.025265766050914875 -0.17 0.5596425882469296 0.559642839828961 5.341916808621061e-07 -0.025279986950382027 -0.17010000000000003 0.5596743530448776 0.559674595038716 5.449688438852185e-07 -0.025294206757665645 -0.17020000000000002 0.5597061136926929 0.5597063459134729 5.55666649776354e-07 -0.02530842547223533 -0.1703 0.5597378701892575 0.5597380924534254 5.662835075859185e-07 -0.02532264309356085 -0.1704 0.5597696225334402 0.5597698346587815 5.76817836994703e-07 -0.02533685962111214 -0.1705 0.5598013707240971 0.5598015725297633 5.872680687579734e-07 -0.02535107505435933 -0.17060000000000003 0.5598331147600701 0.5598333060666063 5.976326447609814e-07 -0.025365289392772734 -0.17070000000000002 0.5598648546401891 0.5598650352695607 6.07910018574076e-07 -0.025379502635822854 -0.1708 0.5598965903632702 0.5598967601388901 6.180986552029033e-07 -0.02539371478298036 -0.1709 0.5599283219281174 0.5599284806748718 6.281970317267849e-07 -0.02540792583371613 -0.171 0.5599600493335215 0.5599601968777966 6.382036372432065e-07 -0.0254221357875012 -0.17110000000000003 0.5599917725782604 0.5599919087479689 6.481169734784409e-07 -0.025436344643806775 -0.17120000000000002 0.5600234916610999 0.5600236162857066 6.57935554565503e-07 -0.02545055240210429 -0.1713 0.5600552065807931 0.5600553194913409 6.676579073494615e-07 -0.02546475906186532 -0.1714 0.5600869173360806 0.560087018365216 6.77282572081328e-07 -0.02547896462256164 -0.1715 0.5601186239256915 0.5601187129076892 6.86808101973968e-07 -0.025493169083665237 -0.17160000000000003 0.5601503263483415 0.5601504031191309 6.962330640070125e-07 -0.025507372444648225 -0.17170000000000002 0.5601820246027354 0.5601820889999245 7.055560387325688e-07 -0.025521574704982942 -0.1718 0.5602137186875654 0.5602137705504655 7.147756206360434e-07 -0.02553577586414187 -0.1719 0.5602454086015123 0.5602454477711629 7.23890418441453e-07 -0.025549975921597724 -0.172 0.5602770943432451 0.5602771206624378 7.328990550836689e-07 -0.025564174876823383 -0.17210000000000003 0.5603087759114213 0.5603087892247237 7.418001684023068e-07 -0.02557837272929192 -0.17220000000000002 0.5603404533046865 0.5603404534584663 7.505924105588591e-07 -0.02559256947847656 -0.1723 0.5603721265216757 0.5603721133641234 7.592744490914072e-07 -0.025606765123850708 -0.1724 0.5604037955610123 0.5604037689421651 7.678449664982878e-07 -0.025620959664888 -0.1725 0.5604354604213083 0.5604354201930732 7.7630266082096e-07 -0.025635153101062205 -0.17260000000000003 0.5604671211011655 0.5604670671173414 7.846462456440051e-07 -0.02564934543184734 -0.17270000000000002 0.5604987775991744 0.560498709715475 7.928744503726826e-07 -0.025663536656717546 -0.1728 0.5605304299139149 0.5605303479879907 8.009860203994634e-07 -0.02567772677514717 -0.1729 0.5605620780439564 0.5605619819354167 8.089797174370972e-07 -0.02569191578661072 -0.173 0.5605937219878578 0.5605936115582928 8.168543193798339e-07 -0.02570610369058296 -0.17310000000000003 0.5606253617441679 0.560625236857169 8.24608620775269e-07 -0.025720290486538757 -0.17320000000000002 0.560656997311425 0.560656857832607 8.322414332129213e-07 -0.02573447617395318 -0.1733 0.5606886286881579 0.5606884744851793 8.39751584685855e-07 -0.02574866075230153 -0.1734 0.5607202558728852 0.5607200868154688 8.471379206453911e-07 -0.025762844221059233 -0.1735 0.5607518788641156 0.5607516948240692 8.543993040843745e-07 -0.02577702657970192 -0.17360000000000003 0.5607834976603487 0.5607832985115844 8.615346149820624e-07 -0.02579120782770542 -0.17370000000000002 0.5608151122600747 0.5608148978786286 8.685427512755695e-07 -0.02580538796454578 -0.1738 0.5608467226617739 0.5608464929258261 8.754226288876232e-07 -0.025819566989699103 -0.1739 0.560878328863918 0.5608780836538114 8.821731815600309e-07 -0.02583374490264184 -0.174 0.5609099308649695 0.5609096700632286 8.887933612422572e-07 -0.025847921702850496 -0.17410000000000003 0.5609415286633825 0.5609412521547312 8.952821381469356e-07 -0.025862097389801875 -0.17420000000000002 0.5609731222576017 0.5609728299289829 9.016385011939576e-07 -0.025876271962972836 -0.1743 0.5610047116460638 0.5610044033866559 9.078614577884281e-07 -0.02589044542184057 -0.1744 0.5610362968271971 0.5610359725284323 9.139500345423102e-07 -0.025904617765882293 -0.1745 0.5610678777994216 0.5610675373550027 9.199032764972692e-07 -0.02591878899457556 -0.17460000000000003 0.5610994545611492 0.5610990978670671 9.25720248290407e-07 -0.025932959107397985 -0.17470000000000002 0.561131027110784 0.5611306540653337 9.314000338211947e-07 -0.025947128103827474 -0.1748 0.5611625954467223 0.5611622059505195 9.36941736195962e-07 -0.025961295983342014 -0.1749 0.5611941595673532 0.5611937535233498 9.423444781719859e-07 -0.025975462745419894 -0.175 0.5612257194710577 0.5612252967845582 9.476074023795356e-07 -0.025989628389539433 -0.17510000000000003 0.5612572751562105 0.5612568357348865 9.527296710998279e-07 -0.026003792915179326 -0.17520000000000002 0.5612888266211786 0.5612883703750841 9.577104668756498e-07 -0.026017956321818293 -0.1753 0.5613203738643222 0.5613199007059081 9.62548992344825e-07 -0.02603211860893532 -0.1754 0.5613519168839951 0.5613514267281235 9.672444704067473e-07 -0.02604627977600958 -0.1755 0.5613834556785438 0.561382948442502 9.717961440558476e-07 -0.026060439822520338 -0.17560000000000003 0.5614149902463094 0.5614144658498234 9.762032772697715e-07 -0.026074598747947198 -0.17570000000000002 0.561446520585626 0.5614459789508739 9.804651544542686e-07 -0.02608875655176983 -0.1758 0.5614780466948224 0.5614774877464466 9.845810808872812e-07 -0.026102913233468153 -0.1759 0.5615095685722211 0.5615089922373417 9.885503825524111e-07 -0.026117068792522236 -0.176 0.5615410862161389 0.5615404924243654 9.92372406694031e-07 -0.026131223228412378 -0.17610000000000003 0.5615725996248871 0.5615719883083308 9.960465214287062e-07 -0.026145376540618992 -0.17620000000000002 0.561604108796772 0.5616034798900561 9.995721163003068e-07 -0.026159528728622733 -0.1763 0.5616356137300949 0.5616349671703669 1.0029486017804068e-06 -0.02617367979190446 -0.1764 0.5616671144231511 0.5616664501500932 1.006175410378507e-06 -0.026187829729945124 -0.1765 0.5616986108742321 0.5616979288300714 1.0092519955873236e-06 -0.026201978542225963 -0.17660000000000003 0.5617301030816247 0.5617294032111435 1.0121778328819886e-06 -0.026216126228228366 -0.17670000000000002 0.5617615910436111 0.561760873294156 1.0149524192759607e-06 -0.02623027278743388 -0.1768 0.5617930747584694 0.561792339079961 1.0175752734875587e-06 -0.026244418219324307 -0.1769 0.5618245542244733 0.5618238005694152 1.020045936439562e-06 -0.026258562523381553 -0.177 0.5618560294398933 0.5618552577633802 1.0223639707040988e-06 -0.026272705699087767 -0.17710000000000004 0.5618875004029955 0.5618867106627219 1.0245289612242914e-06 -0.026286847745925258 -0.17720000000000002 0.5619189671120433 0.5619181592683107 1.0265405146481221e-06 -0.02630098866337653 -0.1773 0.561950429565296 0.5619496035810208 1.0283982603831454e-06 -0.026315128450924305 -0.1774 0.5619818877610104 0.5619810436017307 1.0301018497638204e-06 -0.026329267108051453 -0.1775 0.5620133416974403 0.5620124793313224 1.0316509561625331e-06 -0.026343404634241004 -0.17760000000000004 0.5620447913728364 0.5620439107706816 1.0330452760998199e-06 -0.02635754102897623 -0.17770000000000002 0.5620762367854475 0.5620753379206973 1.0342845279120993e-06 -0.026371676291740583 -0.1778 0.5621076779335196 0.5621067607822614 1.0353684528063845e-06 -0.026385810422017715 -0.1779 0.5621391148152965 0.5621381793562694 1.0362968145827267e-06 -0.026399943419291423 -0.178 0.5621705474290206 0.5621695936436191 1.0370693993566604e-06 -0.02641407528304573 -0.17810000000000004 0.562201975772932 0.5622010036452108 1.0376860163363588e-06 -0.0264282060127648 -0.17820000000000003 0.5622333998452691 0.5622324093619473 1.038146497045478e-06 -0.02644233560793298 -0.17830000000000001 0.5622648196442694 0.5622638107947342 1.0384506961558237e-06 -0.026456464068034896 -0.1784 0.5622962351681694 0.5622952079444782 1.0385984908212187e-06 -0.026470591392555278 -0.1785 0.5623276464152037 0.5623266008120882 1.038589780955057e-06 -0.02648471758097903 -0.17860000000000004 0.5623590533836071 0.5623579893984748 1.0384244897854167e-06 -0.026498842632791314 -0.17870000000000003 0.5623904560716133 0.5623893737045501 1.038102563133414e-06 -0.026512966547477475 -0.17880000000000001 0.5624218544774556 0.562420753731227 1.0376239699128043e-06 -0.02652708932452298 -0.1789 0.5624532485993672 0.5624521294794199 1.0369887016858925e-06 -0.026541210963413504 -0.179 0.5624846384355815 0.5624835009500437 1.036196773218645e-06 -0.026555331463634976 -0.1791 0.5625160239843316 0.5625148681440144 1.0352482221476222e-06 -0.02656945082467347 -0.17920000000000003 0.5625474052438518 0.5625462310622478 1.0341431090354902e-06 -0.026583569046015217 -0.17930000000000001 0.562578782212376 0.5625775897056602 1.0328815176485762e-06 -0.026597686127146625 -0.1794 0.5626101548881396 0.562608944075168 1.0314635545127793e-06 -0.026611802067554383 -0.1795 0.5626415232693787 0.5626402941716875 1.0298893492466377e-06 -0.026625916866725264 -0.1796 0.5626728873543304 0.5626716399961345 1.0281590543392838e-06 -0.02664003052414629 -0.17970000000000003 0.5627042471412336 0.5627029815494244 1.026272845372489e-06 -0.026654143039304697 -0.17980000000000002 0.5627356026283287 0.5627343188324718 1.0242309210761746e-06 -0.026668254411687825 -0.1799 0.5627669538138574 0.5627656518461904 1.022033502884323e-06 -0.026682364640783246 -0.18 0.5627983006960638 0.5627969805914927 1.019680835157022e-06 -0.02669647372607874 -0.1801 0.5628296432731945 0.5628283050692899 1.0171731853469979e-06 -0.026710581667062278 -0.18020000000000003 0.5628609815434976 0.5628596252804916 1.0145108439441053e-06 -0.026724688463221985 -0.18030000000000002 0.5628923155052244 0.5628909412260057 1.011694123975726e-06 -0.026738794114046206 -0.1804 0.5629236451566287 0.5629222529067381 1.0087233614508584e-06 -0.026752898619023413 -0.1805 0.5629549704959673 0.5629535603235928 1.0055989153046063e-06 -0.026767001977642348 -0.1806 0.5629862915215003 0.5629848634774712 1.002321167009601e-06 -0.026781104189391853 -0.18070000000000003 0.5630176082314909 0.5630161623692724 9.98890521186624e-07 -0.02679520525376108 -0.18080000000000002 0.5630489206242061 0.5630474569998927 9.953074047164279e-07 -0.02680930517023927 -0.1809 0.5630802286979164 0.5630787473702256 9.915722670172933e-07 -0.026823403938315893 -0.181 0.5631115324508965 0.5631100334811612 9.87685580766673e-07 -0.026837501557480603 -0.1811 0.5631428318814249 0.5631413153335866 9.836478409575022e-07 -0.026851598027223256 -0.18120000000000003 0.5631741269877848 0.5631725929283851 9.79459564676155e-07 -0.026865693347033856 -0.18130000000000002 0.5632054177682635 0.5632038662664366 9.751212916020435e-07 -0.02687978751640262 -0.1814 0.5632367042211532 0.563235135348617 9.70633584174152e-07 -0.02689388053481997 -0.1815 0.5632679863447512 0.5632664001757983 9.65997026591836e-07 -0.026907972401776503 -0.1816 0.5632992641373598 0.563297660748848 9.612122254809563e-07 -0.026922063116763 -0.18170000000000003 0.5633305375972862 0.5633289170686292 9.56279809671834e-07 -0.026936152679270443 -0.18180000000000002 0.5633618067228439 0.5633601691360004 9.512004300882282e-07 -0.02695024108878999 -0.1819 0.5633930715123509 0.5633914169518148 9.459747597473367e-07 -0.026964328344813018 -0.182 0.5634243319641323 0.5634226605169216 9.406034933157059e-07 -0.026978414446831068 -0.1821 0.5634555880765185 0.5634538998321639 9.350873473867871e-07 -0.026992499394335887 -0.18220000000000003 0.5634868398478464 0.5634851348983796 9.294270602588917e-07 -0.02700658318681938 -0.18230000000000002 0.5635180872764591 0.5635163657164008 9.236233922127468e-07 -0.027020665823773646 -0.1824 0.5635493303607069 0.5635475922870548 9.176771247898508e-07 -0.027034747304691027 -0.1825 0.563580569098946 0.5635788146111612 9.115890607924726e-07 -0.027048827629064 -0.1826 0.5636118034895405 0.5636100326895351 9.053600246167193e-07 -0.02706290679638525 -0.18270000000000003 0.5636430335308611 0.5636412465229843 8.989908619749798e-07 -0.02707698480614768 -0.18280000000000002 0.5636742592212859 0.5636724561123102 8.924824395073472e-07 -0.027091061657844306 -0.1829 0.5637054805592007 0.5637036614583077 8.858356449481519e-07 -0.02710513735096842 -0.183 0.5637366975429992 0.5637348625617649 8.790513867373839e-07 -0.02711921188501347 -0.1831 0.5637679101710826 0.5637660594234624 8.721305944647817e-07 -0.02713328525947306 -0.18320000000000003 0.5637991184418607 0.5637972520441737 8.650742180926763e-07 -0.027147357473841074 -0.18330000000000002 0.563830322353751 0.5638284404246654 8.578832285111027e-07 -0.027161428527611484 -0.1834 0.5638615219051799 0.5638596245656957 8.505586162055323e-07 -0.027175498420278516 -0.1835 0.5638927170945821 0.5638908044680153 8.431013927279185e-07 -0.02718956715133658 -0.1836 0.5639239079204015 0.5639219801323669 8.355125895587179e-07 -0.027203634720280256 -0.18370000000000003 0.5639550943810905 0.5639531515594851 8.277932578848457e-07 -0.02721770112660432 -0.18380000000000002 0.5639862764751109 0.5639843187500961 8.199444691270319e-07 -0.027231766369803734 -0.1839 0.564017454200934 0.5640154817049179 8.119673141904205e-07 -0.02724583044937371 -0.184 0.5640486275570402 0.5640466404246592 8.038629036588585e-07 -0.027259893364809558 -0.1841 0.56407979654192 0.5640777949100206 7.956323673785626e-07 -0.027273955115606825 -0.18420000000000003 0.5641109611540733 0.564108945161693 7.872768546246522e-07 -0.02728801570126125 -0.18430000000000002 0.5641421213920106 0.5641400911803587 7.787975336293051e-07 -0.027302075121268768 -0.1844 0.5641732772542519 0.5641712329666903 7.70195591720535e-07 -0.027316133375125496 -0.1845 0.564204428739328 0.564202370521351 7.614722349058578e-07 -0.02733019046232775 -0.18460000000000001 0.5642355758457799 0.5642335038449942 7.526286879000477e-07 -0.027344246382372 -0.18470000000000003 0.5642667185721596 0.5642646329382636 7.436661938753364e-07 -0.027358301134754973 -0.18480000000000002 0.5642978569170296 0.5642957578017931 7.345860140728355e-07 -0.027372354718973535 -0.1849 0.5643289908789637 0.5643268784362059 7.253894280523365e-07 -0.02738640713452476 -0.185 0.5643601204565466 0.5643579948421156 7.16077733220466e-07 -0.027400458380905914 -0.18510000000000001 0.5643912456483745 0.5643891070201245 7.0665224480293e-07 -0.027414508457614475 -0.1852 0.564422366453055 0.5644202149708246 6.971142956224696e-07 -0.02742855736414808 -0.18530000000000002 0.5644534828692073 0.5644513186947976 6.874652356825273e-07 -0.02744260510000456 -0.1854 0.5644845948954623 0.5644824181926136 6.777064324725579e-07 -0.027456651664681964 -0.1855 0.5645157025304629 0.5645135134648316 6.678392702186287e-07 -0.027470697057678496 -0.18560000000000001 0.5645468057728641 0.5645446045119998 6.57865149994441e-07 -0.02748474127849257 -0.1857 0.5645779046213331 0.5645756913346551 6.477854897213309e-07 -0.027498784326622828 -0.18580000000000002 0.5646089990745493 0.564606773933322 6.376017236409126e-07 -0.027512826201568037 -0.1859 0.5646400891312049 0.5646378523085144 6.273153019820121e-07 -0.02752686690282721 -0.186 0.5646711747900046 0.5646689264607336 6.169276913214894e-07 -0.027540906429899516 -0.18610000000000002 0.5647022560496658 0.5646999963904693 6.064403737515711e-07 -0.027554944782284353 -0.1862 0.5647333329089192 0.5647310620981987 5.958548472961844e-07 -0.027568981959481265 -0.18630000000000002 0.5647644053665081 0.5647621235843872 5.851726251338008e-07 -0.027583017960990032 -0.1864 0.5647954734211891 0.5647931808494876 5.743952355696802e-07 -0.027597052786310583 -0.1865 0.5648265370717327 0.5648242338939404 5.635242221191383e-07 -0.027611086434943102 -0.18660000000000002 0.5648575963169222 0.5648552827181732 5.525611427581456e-07 -0.027625118906387913 -0.1867 0.5648886511555549 0.5648863273226008 5.415075702563943e-07 -0.02763915020014553 -0.18680000000000002 0.5649197015864414 0.5649173677076251 5.303650915666758e-07 -0.02765318031571667 -0.1869 0.5649507476084069 0.5649484038736353 5.191353076305916e-07 -0.027667209252602288 -0.187 0.5649817892202899 0.5649794358210071 5.078198334340644e-07 -0.027681237010303464 -0.18710000000000002 0.5650128264209432 0.5650104635501029 4.964202972856935e-07 -0.027695263588321507 -0.1872 0.5650438592092342 0.5650414870612719 4.849383411775765e-07 -0.0277092889861579 -0.18730000000000002 0.565074887584044 0.5650725063548496 4.7337562011917633e-07 -0.027723313203314344 -0.1874 0.5651059115442689 0.565103521431158 4.6173380210956516e-07 -0.027737336239292722 -0.1875 0.5651369310888193 0.5651345322905053 4.5001456761006864e-07 -0.027751358093595094 -0.18760000000000002 0.5651679462166201 0.5651655389331856 4.3821960976631047e-07 -0.02776537876572372 -0.1877 0.5651989569266118 0.5651965413594793 4.2635063393636763e-07 -0.02777939825518106 -0.18780000000000002 0.565229963217749 0.5652275395696527 4.1440935724668115e-07 -0.027793416561469775 -0.1879 0.565260965089002 0.5652585335639577 4.0239750867532287e-07 -0.02780743368409271 -0.188 0.5652919625393557 0.5652895233426319 3.903168284691283e-07 -0.027821449622552893 -0.18810000000000002 0.5653229555678104 0.5653205089058987 3.781690683518635e-07 -0.02783546437635357 -0.1882 0.5653539441733818 0.5653514902539671 3.6595599077482444e-07 -0.027849477944998147 -0.18830000000000002 0.5653849283551013 0.5653824673870312 3.536793689723483e-07 -0.02786349032799027 -0.1884 0.5654159081120153 0.5654134403052702 3.413409866703798e-07 -0.02787750152483372 -0.1885 0.565446883443186 0.5654444090088488 3.289426377395266e-07 -0.027891511535032523 -0.18860000000000002 0.5654778543476919 0.565475373497917 3.1648612594525893e-07 -0.02790552035809087 -0.1887 0.5655088208246264 0.5655063337726096 3.039732647119875e-07 -0.027919527993513146 -0.18880000000000002 0.5655397828730993 0.5655372898330461 2.914058769981631e-07 -0.027933534440803945 -0.1889 0.5655707404922361 0.565568241679331 2.7878579478279875e-07 -0.027947539699468033 -0.189 0.565601693681179 0.5655991893115541 2.661148589266915e-07 -0.027961543769010406 -0.18910000000000002 0.5656326424390856 0.565630132729789 2.533949189642559e-07 -0.027975546648936225 -0.1892 0.5656635867651302 0.5656610719340943 2.406278327288236e-07 -0.027989548338750836 -0.18930000000000002 0.565694526658503 0.5656920069245132 2.2781546613059867e-07 -0.0280035488379598 -0.1894 0.5657254621184109 0.5657229377010733 2.14959692879102e-07 -0.028017548146068855 -0.1895 0.5657563931440774 0.5657538642637867 2.0206239419173766e-07 -0.02803154626258397 -0.18960000000000002 0.565787319734742 0.5657847866126493 1.8912545858562613e-07 -0.028045543187011253 -0.1897 0.5658182418896612 0.5658157047476422 1.7615078150290397e-07 -0.02805953891885706 -0.18980000000000002 0.5658491596081081 0.5658466186687294 1.6314026510949597e-07 -0.028073533457627888 -0.1899 0.5658800728893726 0.5658775283758601 1.500958179342926e-07 -0.028087526802830505 -0.19 0.5659109817327608 0.5659084338689673 1.3701935473731108e-07 -0.02810151895397178 -0.19010000000000002 0.5659418861375962 0.5659393351479671 1.239127960933617e-07 -0.028115509910558823 -0.1902 0.5659727861032191 0.5659702322127607 1.1077806819081992e-07 -0.02812949967209896 -0.19030000000000002 0.5660036816289868 0.5660011250632329 9.761710244304833e-08 -0.02814348823809966 -0.1904 0.5660345727142735 0.5660320136992519 8.443183533574095e-08 -0.028157475608068645 -0.1905 0.5660654593584702 0.5660628981206703 7.122420807997853e-08 -0.02817146178151378 -0.19060000000000002 0.5660963415609851 0.5660937783273239 5.799616629997839e-08 -0.028185446757943152 -0.1907 0.5661272193212438 0.5661246543190326 4.4749659811049725e-08 -0.02819943053686504 -0.19080000000000003 0.5661580926386888 0.5661555260955995 3.148664228305731e-08 -0.028213413117787908 -0.19090000000000001 0.5661889615127799 0.5661863936568118 1.8209070966335172e-08 -0.028227394500220417 -0.191 0.5662198259429941 0.5662172570024399 4.918906400253054e-09 -0.028241374683671425 -0.19110000000000002 0.5662506859288259 0.566248116132238 -8.381887862604631e-09 -0.02825535366764999 -0.1912 0.5662815414697866 0.5662789710459438 -2.1691345558280672e-08 -0.028269331451665367 -0.1913 0.5663123925654057 0.5663098217432788 -3.500749799073555e-08 -0.028283308035227012 -0.19140000000000001 0.5663432392152289 0.5663406682239471 -4.8328374343230285e-08 -0.028297283417844543 -0.1915 0.5663740814188203 0.5663715104876367 -6.165200195588222e-08 -0.028311257599027792 -0.19160000000000002 0.5664049191757609 0.5664023485340194 -7.497640662143534e-08 -0.02832523057828681 -0.1917 0.5664357524856491 0.5664331823627495 -8.82996128801633e-08 -0.0283392023551318 -0.1918 0.5664665813481012 0.566464011973466 -1.0161964430696613e-07 -0.028353172929073186 -0.19190000000000002 0.5664974057627505 0.5664948373657899 -1.1493452381321212e-07 -0.028367142299621596 -0.192 0.5665282257292478 0.5665256585393263 -1.282422739286304e-07 -0.02838111046628782 -0.19210000000000002 0.5665590412472614 0.5665564754936642 -1.415409171048876e-07 -0.028395077428582896 -0.1922 0.5665898523164773 0.5665872882283743 -1.5482847603304206e-07 -0.028409043186018015 -0.1923 0.5666206589365987 0.5666180967430123 -1.6810297389160955e-07 -0.028423007738104557 -0.19240000000000002 0.5666514611073465 0.5666489010371161 -1.8136243464667023e-07 -0.028436971084354112 -0.1925 0.566682258828459 0.5666797011102079 -1.9460488339534399e-07 -0.028450933224278503 -0.19260000000000002 0.5667130520996918 0.5667104969617927 -2.078283466017128e-07 -0.028464894157389693 -0.1927 0.5667438409208181 0.5667412885913583 -2.2103085245417375e-07 -0.028478853883199852 -0.1928 0.5667746252916289 0.5667720759983772 -2.3421043111176987e-07 -0.028492812401221382 -0.19290000000000002 0.566805405211932 0.5668028591823043 -2.4736511498868463e-07 -0.028506769710966842 -0.193 0.5668361806815533 0.5668336381425783 -2.6049293912894234e-07 -0.028520725811948984 -0.19310000000000002 0.5668669517003354 0.5668644128786208 -2.735919414006971e-07 -0.028534680703680784 -0.1932 0.5668977182681388 0.5668951833898374 -2.8666016281542195e-07 -0.028548634385675398 -0.1933 0.5669284803848413 0.5669259496756172 -2.9969564792342585e-07 -0.0285625868574462 -0.19340000000000002 0.566959238050338 0.5669567117353322 -3.126964449318148e-07 -0.028576538118506717 -0.1935 0.5669899912645414 0.5669874695683386 -3.256606061347034e-07 -0.028590488168370717 -0.19360000000000002 0.5670207400273809 0.5670182231739754 -3.3858618821158704e-07 -0.02860443700655213 -0.1937 0.5670514843388036 0.5670489725515659 -3.5147125240775345e-07 -0.028618384632565098 -0.1938 0.5670822241987736 0.5670797177004163 -3.6431386493673834e-07 -0.028632331045923966 -0.19390000000000002 0.5671129596072725 0.5671104586198168 -3.771120972440034e-07 -0.02864627624614324 -0.194 0.5671436905642987 0.5671411953090416 -3.898640261873476e-07 -0.028660220232737704 -0.19410000000000002 0.5671744170698675 0.5671719277673481 -4.0256773448099636e-07 -0.02867416300522224 -0.1942 0.5672051391240119 0.5672026559939776 -4.152213109870351e-07 -0.028688104563111962 -0.1943 0.5672358567267816 0.5672333799881553 -4.2782285085418703e-07 -0.028702044905922215 -0.19440000000000002 0.567266569878243 0.5672640997490904 -4.4037045603129155e-07 -0.028715984033168513 -0.1945 0.5672972785784797 0.5672948152759758 -4.528622352395484e-07 -0.028729921944366577 -0.19460000000000002 0.5673279828275921 0.5673255265679883 -4.6529630454150706e-07 -0.02874385863903229 -0.1947 0.5673586826256973 0.5673562336242889 -4.776707874798447e-07 -0.028757794116681765 -0.1948 0.5673893779729293 0.5673869364440228 -4.89983815479822e-07 -0.02877172837683132 -0.19490000000000002 0.5674200688694386 0.5674176350263193 -5.022335280574497e-07 -0.028785661418997445 -0.195 0.5674507553153926 0.5674483293702917 -5.144180730831671e-07 -0.028799593242696844 -0.19510000000000002 0.5674814373109746 0.5674790194750375 -5.265356070316418e-07 -0.028813523847446388 -0.1952 0.5675121148563851 0.5675097053396392 -5.385842954397368e-07 -0.02882745323276319 -0.1953 0.5675427879518404 0.5675403869631631 -5.505623131285553e-07 -0.028841381398164525 -0.19540000000000002 0.5675734565975735 0.5675710643446602 -5.624678440785402e-07 -0.028855308343167886 -0.1955 0.5676041207938336 0.5676017374831663 -5.742990825119421e-07 -0.02886923406729096 -0.19560000000000002 0.5676347805408858 0.5676324063777016 -5.860542323377071e-07 -0.02888315857005161 -0.1957 0.5676654358390116 0.5676630710272711 -5.97731507984145e-07 -0.028897081850967933 -0.1958 0.5676960866885082 0.5676937314308647 -6.093291344266838e-07 -0.028911003909558183 -0.19590000000000002 0.5677267330896891 0.567724387587457 -6.208453476042042e-07 -0.028924924745340842 -0.196 0.5677573750428832 0.5677550394960079 -6.322783945023058e-07 -0.028938844357834566 -0.19610000000000002 0.5677880125484349 0.5677856871554623 -6.436265335973967e-07 -0.028952762746558225 -0.1962 0.5678186456067054 0.5678163305647503 -6.548880350232267e-07 -0.028966679911030902 -0.1963 0.56784927421807 0.5678469697227874 -6.660611807929318e-07 -0.02898059585077184 -0.19640000000000002 0.5678798983829204 0.567877604628474 -6.77144265354146e-07 -0.028994510565300502 -0.1965 0.567910518101663 0.5679082352806968 -6.8813559553349e-07 -0.029008424054136547 -0.19660000000000002 0.5679411333747202 0.5679388616783273 -6.990334908973939e-07 -0.029022336316799836 -0.1967 0.5679717442025287 0.5679694838202232 -7.098362838631189e-07 -0.029036247352810407 -0.1968 0.5680023505855407 0.568000101705228 -7.205423202538697e-07 -0.029050157161688513 -0.19690000000000002 0.568032952524223 0.5680307153321708 -7.311499595485937e-07 -0.029064065742954604 -0.197 0.5680635500190576 0.5680613246998668 -7.41657574881982e-07 -0.02907797309612933 -0.19710000000000003 0.5680941430705408 0.5680919298071178 -7.520635533497799e-07 -0.02909187922073353 -0.19720000000000001 0.5681247316791839 0.5681225306527113 -7.623662962863431e-07 -0.02910578411628827 -0.1973 0.5681553158455117 0.5681531272354216 -7.725642197087268e-07 -0.029119687782314753 -0.1974 0.5681858955700645 0.5681837195540094 -7.826557544554635e-07 -0.029133590218334462 -0.1975 0.5682164708533959 0.5682143076072215 -7.926393462420744e-07 -0.02914749142386898 -0.19760000000000003 0.5682470416960741 0.5682448913937923 -8.025134561051583e-07 -0.029161391398440165 -0.19770000000000001 0.5682776080986808 0.5682754709124425 -8.122765606244364e-07 -0.029175290141570054 -0.1978 0.5683081700618118 0.5683060461618801 -8.219271519227522e-07 -0.029189187652780862 -0.1979 0.5683387275860768 0.5683366171408003 -8.314637383877166e-07 -0.029203083931595042 -0.198 0.5683692806720986 0.5683671838478852 -8.408848444219075e-07 -0.029216978977535214 -0.19810000000000003 0.5683998293205134 0.568397746281805 -8.501890109424703e-07 -0.029230872790124204 -0.19820000000000002 0.5684303735319707 0.5684283044412166 -8.59374795519896e-07 -0.02924476536888504 -0.1983 0.5684609133071336 0.5684588583247652 -8.684407727110877e-07 -0.029258656713340932 -0.1984 0.5684914486466776 0.5684894079310836 -8.773855340871162e-07 -0.029272546823015312 -0.1985 0.5685219795512912 0.5685199532587929 -8.862076886773096e-07 -0.029286435697431803 -0.19860000000000003 0.568552506021676 0.5685504943065017 -8.94905862969253e-07 -0.029300323336114237 -0.19870000000000002 0.5685830280585455 0.5685810310728079 -9.034787014361445e-07 -0.02931420973858663 -0.1988 0.568613545662626 0.5686115635562965 -9.119248662592394e-07 -0.029328094904373173 -0.1989 0.568644058834656 0.568642091755542 -9.20243037938473e-07 -0.029341978832998307 -0.199 0.5686745675753855 0.5686726156691075 -9.284319156255272e-07 -0.029355861523986605 -0.19910000000000003 0.5687050718855773 0.5687031352955452 -9.364902169017864e-07 -0.029369742976862945 -0.19920000000000002 0.5687355717660058 0.5687336506333958 -9.44416678166915e-07 -0.02938362319115233 -0.1993 0.5687660672174564 0.5687641616811896 -9.522100548331469e-07 -0.029397502166379954 -0.1994 0.5687965582407264 0.5687946684374459 -9.598691217416189e-07 -0.02941137990207119 -0.1995 0.5688270448366244 0.5688251709006741 -9.673926730235927e-07 -0.02942525639775171 -0.19960000000000003 0.56885752700597 0.5688556690693729 -9.747795226000555e-07 -0.029439131652947283 -0.19970000000000002 0.5688880047495938 0.568886162942031 -9.820285040706977e-07 -0.02945300566718394 -0.1998 0.5689184780683371 0.5689166525171272 -9.89138470963713e-07 -0.02946687843998786 -0.1999 0.568948946963052 0.5689471377931306 -9.961082972353985e-07 -0.02948074997088553 -0.2 0.5689794114346007 0.5689776187685002 -1.0029368769925995e-06 -0.029494620259403467 -0.20010000000000003 0.569009871483856 0.569008095441686 -1.0096231250478205e-06 -0.029508489305068525 -0.20020000000000002 0.5690403271117008 0.5690385678111285 -1.016165977085759e-06 -0.029522357107407693 -0.2003 0.5690707783190274 0.5690690358752593 -1.0225643893302383e-06 -0.029536223665948165 -0.2004 0.5691012251067387 0.5690994996325013 -1.0288173392103417e-06 -0.029550088980217378 -0.2005 0.5691316674757463 0.5691299590812682 -1.0349238255824567e-06 -0.029563953049742932 -0.20060000000000003 0.5691621054269717 0.569160414219965 -1.040882868674764e-06 -0.0295778158740526 -0.20070000000000002 0.5691925389613451 0.5691908650469891 -1.0466935099207042e-06 -0.029591677452674398 -0.2008 0.5692229680798064 0.5692213115607292 -1.0523548130692006e-06 -0.02960553778513658 -0.2009 0.5692533927833038 0.5692517537595662 -1.0578658632409699e-06 -0.02961939687096751 -0.201 0.5692838130727942 0.5692821916418729 -1.0632257682052781e-06 -0.029633254709695786 -0.20110000000000003 0.5693142289492431 0.5693126252060147 -1.068433657158696e-06 -0.029647111300850217 -0.20120000000000002 0.5693446404136241 0.5693430544503494 -1.0734886820573664e-06 -0.029660966643959813 -0.2013 0.569375047466919 0.5693734793732279 -1.078390017394959e-06 -0.029674820738553792 -0.2014 0.5694054501101173 0.5694038999729937 -1.0831368600916491e-06 -0.029688673584161523 -0.2015 0.5694358483442161 0.5694343162479837 -1.087728429882695e-06 -0.02970252518031264 -0.20160000000000003 0.5694662421702203 0.5694647281965279 -1.0921639694294605e-06 -0.029716375526536932 -0.20170000000000002 0.5694966315891419 0.5694951358169503 -1.0964427443194147e-06 -0.029730224622364406 -0.2018 0.5695270166020001 0.5695255391075681 -1.100564043343688e-06 -0.029744072467325272 -0.2019 0.5695573972098206 0.5695559380666927 -1.1045271784970723e-06 -0.02975791906094992 -0.202 0.5695877734136361 0.5695863326926294 -1.1083314850890424e-06 -0.029771764402768977 -0.20210000000000003 0.569618145214486 0.569616722983678 -1.1119763221323353e-06 -0.02978560849231321 -0.20220000000000002 0.5696485126134154 0.5696471089381334 -1.1154610721209046e-06 -0.0297994513291137 -0.2023 0.5696788756114759 0.5696774905542844 -1.118785141362988e-06 -0.029813292912701597 -0.2024 0.569709234209725 0.569707867830415 -1.1219479598145732e-06 -0.029827133242608318 -0.2025 0.5697395884092256 0.5697382407648043 -1.124948981467977e-06 -0.029840972318365445 -0.20260000000000003 0.5697699382110462 0.569768609355727 -1.1277876841297996e-06 -0.029854810139504834 -0.20270000000000002 0.5698002836162603 0.5697989736014533 -1.1304635700870591e-06 -0.02986864670555848 -0.2028 0.5698306246259472 0.569829333500249 -1.1329761655520798e-06 -0.02988248201605856 -0.2029 0.5698609612411901 0.5698596890503762 -1.1353250212176036e-06 -0.02989631607053755 -0.203 0.5698912934630774 0.569890040250093 -1.137509711868212e-06 -0.029910148868528014 -0.20310000000000003 0.5699216212927017 0.5699203870976535 -1.139529836990949e-06 -0.02992398040956275 -0.20320000000000002 0.5699519447311601 0.5699507295913092 -1.1413850203867426e-06 -0.02993781069317482 -0.2033 0.5699822637795533 0.569981067729308 -1.1430749106700056e-06 -0.029951639718897406 -0.2034 0.5700125784389856 0.5700114015098947 -1.1445991809910794e-06 -0.029965467486263928 -0.2035 0.5700428887105657 0.5700417309313117 -1.1459575294248125e-06 -0.029979293994808 -0.20360000000000003 0.5700731945954054 0.5700720559917986 -1.14714967847096e-06 -0.029993119244063476 -0.20370000000000002 0.5701034960946187 0.5701023766895927 -1.1481753760533842e-06 -0.030006943233564315 -0.2038 0.5701337932093237 0.5701326930229293 -1.149034394631876e-06 -0.030020765962844795 -0.2039 0.5701640859406403 0.5701630049900419 -1.1497265316462446e-06 -0.030034587431439275 -0.204 0.5701943742896918 0.570193312589162 -1.1502516095163173e-06 -0.030048407638882415 -0.20410000000000003 0.5702246582576032 0.5702236158185199 -1.150609475863984e-06 -0.030062226584709043 -0.20420000000000002 0.5702549378455013 0.5702539146763448 -1.1508000033466637e-06 -0.03007604426845419 -0.2043 0.5702852130545156 0.5702842091608644 -1.1508230894907712e-06 -0.03008986068965306 -0.2044 0.5703154838857764 0.5703144992703062 -1.1506786573023398e-06 -0.03010367584784109 -0.2045 0.5703457503404158 0.5703447850028965 -1.1503666549339542e-06 -0.03011748974255393 -0.20460000000000003 0.5703760124195671 0.5703750663568616 -1.1498870556847507e-06 -0.030131302373327375 -0.20470000000000002 0.5704062701243642 0.5704053433304279 -1.1492398581114394e-06 -0.030145113739697495 -0.2048 0.5704365234559425 0.5704356159218211 -1.1484250859172818e-06 -0.0301589238412005 -0.2049 0.5704667724154369 0.570465884129268 -1.1474427882851579e-06 -0.030172732677372822 -0.205 0.5704970170039836 0.5704961479509952 -1.146293039433477e-06 -0.0301865402477511 -0.20510000000000003 0.5705272572227182 0.5705264073852306 -1.1449759391712888e-06 -0.030200346551872165 -0.20520000000000002 0.5705574930727764 0.5705566624302028 -1.143491612121128e-06 -0.030214151589273066 -0.2053 0.5705877245552938 0.5705869130841418 -1.1418402084406587e-06 -0.0302279553594911 -0.2054 0.5706179516714049 0.5706171593452785 -1.140021903656141e-06 -0.03024175786206364 -0.2055 0.570648174422244 0.5706474012118458 -1.1380368982738531e-06 -0.03025555909652837 -0.20560000000000003 0.5706783928089438 0.5706776386820782 -1.1358854184462253e-06 -0.030269359062423142 -0.20570000000000002 0.5707086068326362 0.5707078717542127 -1.1335677151946832e-06 -0.03028315775928599 -0.2058 0.5707388164944516 0.5707381004264879 -1.131084064853738e-06 -0.03029695518665514 -0.2059 0.5707690217955181 0.5707683246971452 -1.1284347689599628e-06 -0.030310751344069072 -0.206 0.5707992227369632 0.5707985445644289 -1.1256201541409716e-06 -0.03032454623106645 -0.20610000000000003 0.570829419319911 0.5708287600265861 -1.1226405723374633e-06 -0.030338339847186147 -0.20620000000000002 0.570859611545484 0.570858971081867 -1.11949640024811e-06 -0.030352132191967182 -0.2063 0.5708897994148021 0.5708891777285252 -1.116188039829158e-06 -0.030365923264948875 -0.2064 0.5709199829289822 0.5709193799648179 -1.1127159180723822e-06 -0.030379713065670638 -0.2065 0.5709501620891381 0.5709495777890059 -1.1090804868940651e-06 -0.030393501593672212 -0.20660000000000003 0.5709803368963808 0.5709797711993543 -1.1052822226909065e-06 -0.03040728884849339 -0.20670000000000002 0.5710105073518176 0.5710099601941323 -1.1013216271726911e-06 -0.030421074829674283 -0.2068 0.5710406734565523 0.5710401447716134 -1.0971992269737108e-06 -0.030434859536755177 -0.2069 0.5710708352116849 0.5710703249300763 -1.092915572875608e-06 -0.030448642969276542 -0.207 0.5711009926183112 0.5711005006678038 -1.0884712406400432e-06 -0.030462425126779033 -0.20710000000000003 0.5711311456775227 0.5711306719830845 -1.0838668306201171e-06 -0.03047620600880358 -0.20720000000000002 0.5711612943904064 0.571160838874212 -1.0791029675938368e-06 -0.03048998561489126 -0.2073 0.5711914387580447 0.5711910013394854 -1.0741803008196271e-06 -0.030503763944583342 -0.2074 0.5712215787815148 0.5712211593772096 -1.0690995037032636e-06 -0.03051754099742129 -0.2075 0.5712517144618889 0.5712513129856956 -1.063861274297473e-06 -0.030531316772946848 -0.20760000000000003 0.5712818458002343 0.5712814621632606 -1.0584663344692657e-06 -0.030545091270701936 -0.20770000000000002 0.5713119727976119 0.5713116069082276 -1.0529154301774923e-06 -0.030558864490228595 -0.2078 0.5713420954550776 0.5713417472189269 -1.0472093313618203e-06 -0.030572636431069146 -0.2079 0.571372213773681 0.5713718830936955 -1.0413488321092679e-06 -0.030586407092766117 -0.208 0.5714023277544652 0.5714020145308768 -1.0353347499880705e-06 -0.030600176474862198 -0.20810000000000003 0.5714324373984669 0.5714321415288222 -1.0291679264362585e-06 -0.03061394457690031 -0.20820000000000002 0.571462542706717 0.5714622640858901 -1.0228492260955235e-06 -0.03062771139842356 -0.2083 0.5714926436802388 0.5714923822004465 -1.016379537088774e-06 -0.030641476938975294 -0.2084 0.5715227403200489 0.5715224958708658 -1.0097597713532025e-06 -0.030655241198099016 -0.2085 0.5715528326271564 0.5715526050955295 -1.0029908635300622e-06 -0.030669004175338438 -0.20860000000000004 0.5715829206025631 0.5715827098728283 -9.960737715197787e-07 -0.03068276587023754 -0.20870000000000002 0.5716130042472632 0.5716128102011608 -9.89009476037861e-07 -0.03069652628234041 -0.2088 0.5716430835622434 0.5716429060789343 -9.81798980670412e-07 -0.03071028541119138 -0.2089 0.5716731585484816 0.5716729975045652 -9.744433115688178e-07 -0.030724043256335012 -0.209 0.5717032292069478 0.5717030844764787 -9.66943517421992e-07 -0.030737799817316017 -0.20910000000000004 0.5717332955386039 0.5717331669931093 -9.5930066942862e-07 -0.03075155509367938 -0.20920000000000002 0.5717633575444026 0.571763245052901 -9.51515860880825e-07 -0.030765309084970213 -0.2093 0.5717934152252884 0.5717933186543077 -9.435902071919244e-07 -0.03077906179073392 -0.2094 0.5718234685821961 0.5718233877957928 -9.355248456466292e-07 -0.030792813210516037 -0.2095 0.5718535176160517 0.5718534524758296 -9.273209355398215e-07 -0.030806563343862295 -0.20960000000000004 0.5718835623277718 0.5718835126929023 -9.189796572051101e-07 -0.030820312190318708 -0.20970000000000003 0.571913602718263 0.5719135684455048 -9.10502212986275e-07 -0.030834059749431365 -0.20980000000000001 0.5719436387884227 0.571943619732142 -9.018898261270447e-07 -0.03084780602074674 -0.2099 0.5719736705391378 0.5719736665513293 -8.931437411041632e-07 -0.03086155100381135 -0.21 0.5720036979712854 0.5720037089015936 -8.842652234331005e-07 -0.030875294698171976 -0.2101 0.5720337210857319 0.5720337467814722 -8.752555590851863e-07 -0.030889037103375594 -0.21020000000000003 0.5720637398833331 0.5720637801895148 -8.661160548484315e-07 -0.030902778218969397 -0.21030000000000001 0.5720937543649349 0.5720938091242815 -8.568480375503729e-07 -0.030916518044500813 -0.2104 0.5721237645313715 0.5721238335843449 -8.474528546131843e-07 -0.03093025657951742 -0.2105 0.572153770383466 0.5721538535682892 -8.37931873054476e-07 -0.03094399382356701 -0.2106 0.5721837719220308 0.5721838690747107 -8.282864800979173e-07 -0.030957729776197585 -0.21070000000000003 0.5722137691478665 0.5722138801022181 -8.185180821740357e-07 -0.030971464436957363 -0.21080000000000002 0.5722437620617619 0.5722438866494322 -8.086281053087951e-07 -0.03098519780539474 -0.2109 0.5722737506644944 0.5722738887149865 -7.986179946795069e-07 -0.030998929881058363 -0.211 0.5723037349568295 0.5723038862975274 -7.884892144482958e-07 -0.03101266066349703 -0.2111 0.57233371493952 0.5723338793957145 -7.782432475678114e-07 -0.031026390152259754 -0.21120000000000003 0.572363690613307 0.5723638680082196 -7.678815955314278e-07 -0.031040118346895768 -0.21130000000000002 0.572393661978919 0.5723938521337286 -7.574057780956878e-07 -0.031053845246954526 -0.2114 0.572423629037072 0.5724238317709407 -7.468173334190809e-07 -0.031067570851985672 -0.2115 0.5724535917884689 0.5724538069185683 -7.361178172293759e-07 -0.031081295161539027 -0.2116 0.5724835502337997 0.5724837775753377 -7.253088031566879e-07 -0.031095018175164624 -0.21170000000000003 0.5725135043737416 0.5725137437399895 -7.143918820951001e-07 -0.031108739892412758 -0.21180000000000002 0.5725434542089584 0.572543705411278 -7.03368662369197e-07 -0.031122460312833857 -0.2119 0.5725733997401005 0.5725736625879716 -6.922407690401755e-07 -0.031136179435978597 -0.212 0.5726033409678046 0.5726036152688534 -6.810098441001333e-07 -0.031149897261397837 -0.2121 0.5726332778926939 0.5726335634527209 -6.696775460557358e-07 -0.031163613788642665 -0.21220000000000003 0.5726632105153777 0.572663507138386 -6.582455496506601e-07 -0.03117732901726432 -0.21230000000000002 0.5726931388364513 0.5726934463246757 -6.467155455047724e-07 -0.031191042946814303 -0.2124 0.5727230628564957 0.572723381010432 -6.350892402529063e-07 -0.031204755576844302 -0.2125 0.5727529825760778 0.5727533111945117 -6.233683558232173e-07 -0.031218466906906196 -0.2126 0.5727828979957502 0.5727832368757871 -6.115546296314722e-07 -0.031232176936552093 -0.21270000000000003 0.5728128091160507 0.5728131580531459 -5.996498139149153e-07 -0.03124588566533429 -0.21280000000000002 0.5728427159375025 0.5728430747254911 -5.876556758988016e-07 -0.0312595930928053 -0.2129 0.5728726184606139 0.5728729868917415 -5.755739971025076e-07 -0.031273299218517826 -0.213 0.5729025166858782 0.5729028945508315 -5.634065733117755e-07 -0.03128700404202479 -0.2131 0.5729324106137739 0.5729327977017117 -5.511552144399356e-07 -0.031300707562879296 -0.21320000000000003 0.5729623002447639 0.5729626963433482 -5.388217439450393e-07 -0.03131440978063467 -0.21330000000000002 0.5729921855792961 0.5729925904747238 -5.264079988021031e-07 -0.03132811069484447 -0.2134 0.5730220666178027 0.5730224800948374 -5.13915829225553e-07 -0.03134181030506241 -0.2135 0.5730519433607005 0.573052365202704 -5.013470981418688e-07 -0.03135550861084243 -0.2136 0.5730818158083907 0.5730822457973556 -4.887036812312173e-07 -0.0313692056117387 -0.21370000000000003 0.573111683961258 0.5731121218778401 -4.75987466483363e-07 -0.031382901307305526 -0.21380000000000002 0.573141547819672 0.5731419934432231 -4.63200353878479e-07 -0.0313965956970975 -0.2139 0.5731714073839861 0.5731718604925864 -4.5034425530388056e-07 -0.03141028878066939 -0.214 0.5732012626545373 0.5732017230250287 -4.374210940821799e-07 -0.03142398055757615 -0.2141 0.5732311136316466 0.573231581039666 -4.2443280474924183e-07 -0.03143767102737296 -0.21420000000000003 0.5732609603156182 0.5732614345356316 -4.1138133276275024e-07 -0.031451360189615196 -0.21430000000000002 0.5732908027067407 0.5732912835120756 -3.9826863425240777e-07 -0.03146504804385845 -0.2144 0.5733206408052851 0.5733211279681656 -3.8509667553421334e-07 -0.03147873458965849 -0.2145 0.5733504746115067 0.573350967903087 -3.7186743317985105e-07 -0.03149241982657134 -0.2146 0.5733803041256436 0.5733808033160424 -3.5858289339218974e-07 -0.03150610375415319 -0.21470000000000003 0.5734101293479171 0.573410634206252 -3.4524505185262733e-07 -0.03151978637196045 -0.21480000000000002 0.5734399502785317 0.573440460572954 -3.318559134019017e-07 -0.031533467679549725 -0.2149 0.5734697669176748 0.5734702824154041 -3.1841749176253487e-07 -0.03154714767647786 -0.215 0.5734995792655171 0.5735000997328761 -3.0493180919188845e-07 -0.03156082636230186 -0.2151 0.5735293873222117 0.5735299125246617 -2.9140089619072995e-07 -0.03157450373657897 -0.21520000000000003 0.5735591910878948 0.5735597207900703 -2.7782679118404374e-07 -0.03158817979886661 -0.21530000000000002 0.5735889905626848 0.5735895245284302 -2.642115403128642e-07 -0.03160185454872244 -0.2154 0.5736187857466831 0.573619323739087 -2.50557197024881e-07 -0.03161552798570432 -0.2155 0.5736485766399737 0.5736491184214052 -2.3686582173443327e-07 -0.03162920010937026 -0.2156 0.5736783632426231 0.5736789085747671 -2.231394816420984e-07 -0.03164287091927858 -0.21570000000000003 0.5737081455546801 0.573708694198574 -2.0938025033223617e-07 -0.03165654041498771 -0.21580000000000002 0.5737379235761758 0.5737384752922449 -1.955902074884941e-07 -0.031670208596056335 -0.2159 0.5737676973071235 0.573768251855218 -1.8177143854686273e-07 -0.03168387546204331 -0.216 0.5737974667475192 0.5737980238869496 -1.679260344597533e-07 -0.031697541012507754 -0.21610000000000001 0.5738272318973408 0.573827791386915 -1.5405609123803066e-07 -0.03171120524700894 -0.2162 0.5738569927565486 0.5738575543546076 -1.401637097844799e-07 -0.03172486816510639 -0.21630000000000002 0.5738867493250844 0.57388731278954 -1.2625099552257546e-07 -0.031738529766359797 -0.2164 0.5739165016028729 0.5739170666912433 -1.1232005805994483e-07 -0.03175219005032908 -0.2165 0.57394624958982 0.5739468160592675 -9.837301085183214e-08 -0.031765849016574345 -0.21660000000000001 0.5739759932858143 0.5739765608931814 -8.441197094435915e-08 -0.03177950666465592 -0.2167 0.5740057326907259 0.5740063011925725 -7.043905859462074e-08 -0.03179316299413434 -0.21680000000000002 0.5740354678044068 0.5740360369570475 -5.645639697231253e-08 -0.03180681800457033 -0.2169 0.5740651986266913 0.5740657681862319 -4.246611183967436e-08 -0.03182047169552485 -0.217 0.5740949251573951 0.57409549487977 -2.847033121582132e-08 -0.031834124066559055 -0.21710000000000002 0.574124647396316 0.5741252170373253 -1.4471185075443961e-08 -0.031847775117234293 -0.2172 0.5741543653432332 0.5741549346585804 -4.708050017551701e-10 -0.03186142484711212 -0.21730000000000002 0.5741840789979081 0.5741846477432363 1.3528676130747375e-08 -0.03187507325575432 -0.2174 0.574213788360084 0.5742143562910137 2.7525124483493424e-08 -0.03188872034272287 -0.2175 0.5742434934294854 0.5742440603016521 4.1516405566849324e-08 -0.03190236610757995 -0.21760000000000002 0.574273194205819 0.5742737597749101 5.550038458673745e-08 -0.03191601054988795 -0.2177 0.5743028906887734 0.5743034547105654 6.947492675948852e-08 -0.031929653669209496 -0.21780000000000002 0.5743325828780184 0.5743331451084147 8.343789764664322e-08 -0.031943295465107366 -0.2179 0.5743622707732056 0.5743628309682737 9.738716345852882e-08 -0.03195693593714459 -0.218 0.5743919543739685 0.5743925122899771 1.1132059139773443e-07 -0.03197057508488435 -0.21810000000000002 0.5744216336799225 0.574422189073379 1.2523605001646398e-07 -0.0319842129078901 -0.2182 0.5744513086906647 0.5744518613183527 1.3913140945592817e-07 -0.03199784940572548 -0.21830000000000002 0.5744809794057738 0.5744815290247898 1.5300454189737245e-07 -0.03201148457795432 -0.2184 0.5745106458248104 0.5745111921926014 1.6685332174248835e-07 -0.03202511842414068 -0.2185 0.5745403079473165 0.5745408508217179 1.8067562609219712e-07 -0.0320387509438488 -0.21860000000000002 0.5745699657728164 0.5745705049120882 1.9446933498257213e-07 -0.03205238213664315 -0.2187 0.5745996193008158 0.5746001544636806 2.082323316970891e-07 -0.03206601200208839 -0.21880000000000002 0.5746292685308027 0.574629799476482 2.2196250314826527e-07 -0.03207964053974942 -0.2189 0.5746589134622468 0.5746594399504983 2.3565774019684849e-07 -0.032093267749191294 -0.219 0.5746885540945994 0.5746890758857546 2.493159379501897e-07 -0.03210689362997932 -0.21910000000000002 0.5747181904272941 0.5747187072822946 2.629349959981653e-07 -0.03212051818167899 -0.2192 0.5747478224597464 0.574748334140181 2.765128190029831e-07 -0.03213414140385603 -0.21930000000000002 0.5747774501913538 0.5747779564594948 2.900473167616324e-07 -0.032147763296076326 -0.2194 0.5748070736214959 0.5748075742403366 3.0353640460833997e-07 -0.032161383857906026 -0.2195 0.5748366927495338 0.5748371874828251 3.169780038725367e-07 -0.032175003088911434 -0.21960000000000002 0.5748663075748115 0.5748667961870979 3.303700419898803e-07 -0.03218862098865911 -0.2197 0.574895918096655 0.5748964003533111 3.437104528214441e-07 -0.032202237556715765 -0.21980000000000002 0.5749255243143725 0.5749259999816396 3.5699717729209546e-07 -0.03221585279264839 -0.2199 0.5749551262272543 0.5749555950722764 3.702281632933513e-07 -0.03222946669602413 -0.22 0.5749847238345732 0.5749851856254334 3.8340136629400057e-07 -0.03224307926641034 -0.22010000000000002 0.5750143171355847 0.5750147716413404 3.965147494927601e-07 -0.03225669050337459 -0.2202 0.5750439061295263 0.5750443531202462 4.095662843317527e-07 -0.03227030040648469 -0.22030000000000002 0.5750734908156183 0.575073930062417 4.225539505103848e-07 -0.03228390897530863 -0.2204 0.5751030711930637 0.575103502468138 4.354757365682138e-07 -0.03229751620941459 -0.2205 0.5751326472610478 0.575133070337712 4.4832964019025923e-07 -0.03231112210837098 -0.22060000000000002 0.5751622190187391 0.57516263367146 4.6111366827639166e-07 -0.03232472667174641 -0.2207 0.5751917864652886 0.5751921924697211 4.738258374686888e-07 -0.0323383298991097 -0.22080000000000002 0.5752213495998304 0.575221746732852 4.864641744151132e-07 -0.03235193179002989 -0.2209 0.5752509084214817 0.5752512964612274 4.990267160331907e-07 -0.0323655323440762 -0.221 0.5752804629293428 0.5752808416552396 5.11511509954099e-07 -0.032379131560818106 -0.22110000000000002 0.5753100131224967 0.575310382315299 5.239166145643015e-07 -0.03239272943982525 -0.2212 0.5753395590000103 0.5753399184418327 5.362400995745364e-07 -0.032406325980667484 -0.22130000000000002 0.5753691005609334 0.5753694500352858 5.48480046214106e-07 -0.03241992118291488 -0.2214 0.5753986378042997 0.5753989770961209 5.606345475916985e-07 -0.03243351504613775 -0.2215 0.5754281707291257 0.5754284996248171 5.727017087231445e-07 -0.03244710756990652 -0.22160000000000002 0.5754576993344125 0.5754580176218714 5.846796472808169e-07 -0.03246069875379194 -0.2217 0.5754872236191443 0.5754875310877975 5.965664937046533e-07 -0.03247428859736488 -0.22180000000000002 0.5755167435822897 0.5755170400231262 6.083603911188895e-07 -0.03248787710019648 -0.22190000000000001 0.5755462592228004 0.5755465444284049 6.200594963035044e-07 -0.03250146426185803 -0.222 0.5755757705396134 0.5755760443041978 6.316619794166645e-07 -0.03251505008192107 -0.22210000000000002 0.5756052775316489 0.5756055396510857 6.43166024549835e-07 -0.03252863455995735 -0.2222 0.5756347801978121 0.575635030469666 6.54569830005336e-07 -0.03254221769553881 -0.2223 0.5756642785369921 0.5756645167605523 6.658716086849203e-07 -0.03255579948823759 -0.22240000000000001 0.5756937725480629 0.5756939985243745 6.770695880620181e-07 -0.03256937993762607 -0.2225 0.5757232622298829 0.5757234757617783 6.88162010542559e-07 -0.03258295904327681 -0.22260000000000002 0.5757527475812959 0.5757529484734261 6.991471339923283e-07 -0.03259653680476258 -0.2227 0.5757822286011303 0.5757824166599956 7.100232320145228e-07 -0.032610113221656405 -0.2228 0.5758117052881995 0.5758118803221801 7.207885936999503e-07 -0.032623688293531454 -0.22290000000000001 0.5758411776413019 0.5758413394606888 7.314415246262307e-07 -0.03263726201996112 -0.223 0.575870645659222 0.5758707940762464 7.419803464969732e-07 -0.032650834400519045 -0.22310000000000002 0.5759001093407288 0.5759002441695928 7.524033977523992e-07 -0.03266440543477905 -0.2232 0.5759295686845781 0.5759296897414828 7.62709033902409e-07 -0.03267797512231515 -0.2233 0.5759590236895109 0.5759591307926866 7.728956275543375e-07 -0.03269154346270161 -0.22340000000000002 0.5759884743542537 0.5759885673239891 7.829615687737768e-07 -0.03270511045551285 -0.2235 0.5760179206775197 0.5760179993361896 7.929052653066204e-07 -0.03271867610032354 -0.22360000000000002 0.5760473626580082 0.5760474268301027 8.027251429676419e-07 -0.032732240396708544 -0.2237 0.5760768002944048 0.576076849806557 8.124196458070276e-07 -0.032745803344243006 -0.2238 0.5761062335853817 0.5761062682663952 8.219872361936442e-07 -0.03275936494250212 -0.22390000000000002 0.5761356625295976 0.5761356822104743 8.314263953423939e-07 -0.03277292519106142 -0.224 0.5761650871256984 0.576165091639665 8.407356234529928e-07 -0.03278648408949658 -0.22410000000000002 0.5761945073723168 0.5761944965548524 8.499134399320152e-07 -0.03280004163738354 -0.2242 0.5762239232680727 0.5762238969569344 8.589583834761605e-07 -0.032813597834298415 -0.2243 0.5762533348115737 0.5762532928468229 8.67869012738387e-07 -0.03282715267981757 -0.22440000000000002 0.5762827420014143 0.5762826842254428 8.766439060503561e-07 -0.03284070617351747 -0.2245 0.5763121448361774 0.5763120710937324 8.85281662033055e-07 -0.032854258314974925 -0.22460000000000002 0.5763415433144332 0.5763414534526424 8.937808995967966e-07 -0.0328678091037669 -0.2247 0.5763709374347402 0.5763708313031367 9.021402584685756e-07 -0.03288135853947051 -0.2248 0.5764003271956453 0.5764002046461916 9.103583988312458e-07 -0.032894906621663174 -0.22490000000000002 0.5764297125956833 0.576429573482796 9.184340022949655e-07 -0.03290845334992245 -0.225 0.5764590936333782 0.5764589378139506 9.263657714531082e-07 -0.03292199872382617 -0.22510000000000002 0.5764884703072425 0.5764882976406687 9.34152430492885e-07 -0.032935542742952316 -0.2252 0.5765178426157773 0.5765176529639748 9.417927253618785e-07 -0.03294908540687911 -0.2253 0.5765472105574735 0.5765470037849055 9.492854236847759e-07 -0.03296262671518496 -0.22540000000000002 0.5765765741308109 0.5765763501045086 9.566293155127692e-07 -0.03297616666744853 -0.2255 0.5766059333342589 0.5766056919238435 9.638232127961999e-07 -0.03298970526324864 -0.22560000000000002 0.5766352881662768 0.5766350292439805 9.70865950133959e-07 -0.03300324250216436 -0.2257 0.5766646386253138 0.5766643620660005 9.777563850787985e-07 -0.033016778383774946 -0.2258 0.5766939847098087 0.5766936903909955 9.8449339758222e-07 -0.03303031290765986 -0.22590000000000002 0.5767233264181912 0.5767230142200679 9.910758910214312e-07 -0.033043846073398796 -0.226 0.5767526637488812 0.5767523335543303 9.97502791755256e-07 -0.033057377880571635 -0.22610000000000002 0.5767819967002898 0.5767816483949053 1.0037730498457798e-06 -0.033070908328758496 -0.2262 0.5768113252708186 0.5768109587429257 1.0098856387807942e-06 -0.03308443741753967 -0.2263 0.57684064945886 0.5768402645995336 1.0158395557513522e-06 -0.033097965146495704 -0.22640000000000002 0.5768699692627983 0.5768695659658808 1.0216338219293242e-06 -0.03311149151520732 -0.2265 0.5768992846810093 0.5768988628431284 1.0272674826894423e-06 -0.03312501652325543 -0.22660000000000002 0.57692859571186 0.5769281552324462 1.032739607664812e-06 -0.03313854017022121 -0.2267 0.57695790235371 0.5769574431350136 1.0380492909134453e-06 -0.033152062455686034 -0.2268 0.5769872046049107 0.5769867265520177 1.0431956506407047e-06 -0.033165583379231436 -0.22690000000000002 0.577016502463806 0.5770160054846547 1.048177830753616e-06 -0.03317910294043924 -0.227 0.5770457959287325 0.5770452799341289 1.0529949989734888e-06 -0.03319262113889141 -0.22710000000000002 0.5770750849980192 0.5770745499016521 1.0576463486677845e-06 -0.033206137974170144 -0.2272 0.5771043696699887 0.5771038153884444 1.0621310981839827e-06 -0.03321965344585785 -0.2273 0.5771336499429564 0.5771330763957332 1.0664484913491812e-06 -0.03323316755353717 -0.22740000000000002 0.5771629258152313 0.5771623329247535 1.0705977971370295e-06 -0.03324668029679094 -0.2275 0.5771921972851164 0.5771915849767469 1.0745783102228401e-06 -0.033260191675202166 -0.22760000000000002 0.5772214643509079 0.5772208325529622 1.0783893509280773e-06 -0.03327370168835407 -0.2277 0.577250727010897 0.577250075654655 1.0820302652758684e-06 -0.0332872103358302 -0.2278 0.5772799852633685 0.5772793142830872 1.0855004252685596e-06 -0.03330071761721416 -0.22790000000000002 0.5773092391066027 0.5773085484395268 1.0887992291652715e-06 -0.0333142235320899 -0.228 0.5773384885388737 0.5773377781252479 1.0919261008712766e-06 -0.03332772808004144 -0.22810000000000002 0.5773677335584512 0.57736700334153 1.0948804911592447e-06 -0.03334123126065312 -0.22820000000000001 0.5773969741636003 0.5773962240896588 1.0976618765035084e-06 -0.03335473307350947 -0.2283 0.5774262103525811 0.5774254403709247 1.1002697603568201e-06 -0.033368233518195164 -0.2284 0.5774554421236501 0.5774546521866234 1.1027036723731953e-06 -0.033381732594295166 -0.2285 0.577484669475059 0.5774838595380554 1.1049631690185358e-06 -0.03339523030139461 -0.22860000000000003 0.5775138924050566 0.5775130624265259 1.1070478334040956e-06 -0.03340872663907889 -0.22870000000000001 0.5775431109118871 0.5775422608533443 1.1089572752864818e-06 -0.03342222160693351 -0.2288 0.5775723249937921 0.5775714548198239 1.1106911313452095e-06 -0.033435715204544275 -0.2289 0.5776015346490102 0.5776006443272825 1.1122490652937245e-06 -0.03344920743149717 -0.229 0.5776307398757765 0.5776298293770412 1.1136307678794033e-06 -0.03346269828737843 -0.22910000000000003 0.5776599406723242 0.5776590099704244 1.1148359566059973e-06 -0.03347618777177437 -0.22920000000000001 0.5776891370368835 0.5776881861087597 1.1158643763997667e-06 -0.03348967588427169 -0.2293 0.5777183289676829 0.577717357793378 1.1167157992764132e-06 -0.0335031626244572 -0.2294 0.5777475164629489 0.5777465250256125 1.1173900243965917e-06 -0.03351664799191794 -0.2295 0.5777766995209059 0.5777756878067991 1.1178868784544882e-06 -0.03353013198624113 -0.22960000000000003 0.5778058781397776 0.5778048461382757 1.1182062152337302e-06 -0.033543614607014265 -0.22970000000000002 0.5778350523177858 0.5778340000213825 1.1183479158294318e-06 -0.03355709585382501 -0.2298 0.577864222053152 0.5778631494574612 1.1183118888702381e-06 -0.03357057572626126 -0.2299 0.5778933873440966 0.5778922944478552 1.118098070407303e-06 -0.03358405422391111 -0.23 0.5779225481888395 0.5779214349939088 1.1177064239142886e-06 -0.033597531346362834 -0.23010000000000003 0.5779517045856004 0.5779505710969675 1.1171369403983888e-06 -0.03361100709320494 -0.23020000000000002 0.5779808565325992 0.5779797027583775 1.1163896381782834e-06 -0.03362448146402614 -0.2303 0.5780100040280564 0.5780088299794861 1.1154645632172056e-06 -0.03363795445841549 -0.2304 0.578039147070192 0.5780379527616403 1.1143617890119195e-06 -0.03365142607596199 -0.2305 0.5780682856572276 0.5780670711061873 1.113081416426187e-06 -0.033664896316255126 -0.23060000000000003 0.5780974197873854 0.5780961850144741 1.1116235739128122e-06 -0.0336783651788844 -0.23070000000000002 0.5781265494588889 0.5781252944878472 1.1099884174581298e-06 -0.03369183266343962 -0.2308 0.5781556746699632 0.5781543995276526 1.1081761306930282e-06 -0.03370529876951075 -0.2309 0.578184795418835 0.5781835001352353 1.1061869246153933e-06 -0.033718763496688016 -0.231 0.578213911703733 0.578212596311939 1.1040210376456194e-06 -0.033732226844561834 -0.23110000000000003 0.5782430235228879 0.5782416880591061 1.1016787356821212e-06 -0.03374568881272281 -0.23120000000000002 0.5782721308745331 0.5782707753780775 1.0991603120458215e-06 -0.033759149400761794 -0.2313 0.5783012337569046 0.5782998582701921 1.0964660875356635e-06 -0.03377260860826985 -0.2314 0.5783303321682413 0.5783289367367869 1.0935964102065654e-06 -0.03378606643483822 -0.2315 0.578359426106785 0.5783580107791957 1.0905516553694206e-06 -0.03379952288005836 -0.23160000000000003 0.5783885155707819 0.5783870803987505 1.0873322260906981e-06 -0.03381297794352199 -0.23170000000000002 0.5784176005584805 0.5784161455967805 1.0839385519711975e-06 -0.033826431624821005 -0.2318 0.5784466810681339 0.5784452063746113 1.0803710904228048e-06 -0.0338398839235475 -0.2319 0.5784757570979995 0.5784742627335653 1.0766303257803145e-06 -0.03385333483929378 -0.232 0.5785048286463383 0.5785033146749616 1.0727167692459183e-06 -0.03386678437165238 -0.23210000000000003 0.578533895711417 0.5785323622001153 1.0686309593332943e-06 -0.03388023252021602 -0.23220000000000002 0.5785629582915062 0.5785614053103373 1.0643734614235179e-06 -0.03389367928457768 -0.2323 0.5785920163848821 0.5785904440069343 1.059944867654039e-06 -0.03390712466433051 -0.2324 0.5786210699898262 0.5786194782912089 1.0553457970852165e-06 -0.03392056865906794 -0.2325 0.578650119104625 0.5786485081644582 1.05057689536725e-06 -0.033934011268383475 -0.23260000000000003 0.5786791637275717 0.5786775336279746 1.0456388348512036e-06 -0.03394745249187093 -0.23270000000000002 0.5787082038569649 0.5787065546830457 1.0405323145890044e-06 -0.033960892329124366 -0.2328 0.5787372394911096 0.578735571330953 1.03525805966731e-06 -0.03397433077973797 -0.2329 0.5787662706283173 0.5787645835729722 1.0298168219846637e-06 -0.03398776784330617 -0.233 0.5787952972669064 0.5787935914103739 1.0242093793633167e-06 -0.03400120351942362 -0.23310000000000003 0.578824319405202 0.5788225948444219 1.0184365360488279e-06 -0.03401463780768518 -0.23320000000000002 0.5788533370415365 0.5788515938763735 1.0124991219884194e-06 -0.0340280707076859 -0.2333 0.5788823501742499 0.5788805885074797 1.0063979932750655e-06 -0.0340415022190211 -0.2334 0.5789113588016899 0.5789095787389844 1.0001340317589147e-06 -0.034054932341286225 -0.2335 0.5789403629222116 0.5789385645721247 9.937081449917784e-07 -0.03406836107407702 -0.23360000000000003 0.5789693625341786 0.5789675460081298 9.871212661161088e-07 -0.034081788416989355 -0.23370000000000002 0.578998357635963 0.5789965230482219 9.803743536429543e-07 -0.034095214369619396 -0.2338 0.5790273482259449 0.5790254956936152 9.73468391340937e-07 -0.034108638931563476 -0.2339 0.5790563343025141 0.5790544639455159 9.664043880697193e-07 -0.03412206210241813 -0.234 0.5790853158640684 0.5790834278051219 9.591833779465375e-07 -0.03413548388178016 -0.23410000000000003 0.5791142929090156 0.5791123872736228 9.518064197910903e-07 -0.03414890426924647 -0.23420000000000002 0.5791432654357725 0.5791413423521995 9.44274597153294e-07 -0.03416232326441434 -0.2343 0.5791722334427659 0.5791702930420239 9.365890182855274e-07 -0.03417574086688109 -0.2344 0.5792011969284323 0.5791992393442588 9.287508155042534e-07 -0.03418915707624437 -0.2345 0.5792301558912185 0.5792281812600578 9.207611457451303e-07 -0.03420257189210201 -0.23460000000000003 0.5792591103295817 0.5792571187905647 9.126211895638114e-07 -0.03421598531405203 -0.23470000000000002 0.5792880602419891 0.5792860519369138 9.043321518575897e-07 -0.03422939734169269 -0.2348 0.5793170056269192 0.5793149807002295 8.958952611159976e-07 -0.03424280797462244 -0.2349 0.5793459464828615 0.5793439050816257 8.873117692820287e-07 -0.03425621721243998 -0.235 0.5793748828083164 0.5793728250822059 8.785829517243826e-07 -0.03426962505474415 -0.23510000000000003 0.5794038146017959 0.5794017407030632 8.697101071541979e-07 -0.03428303150113409 -0.23520000000000002 0.5794327418618234 0.57943065194528 8.606945571254521e-07 -0.03429643655120907 -0.2353 0.5794616645869344 0.5794595588099272 8.515376459239388e-07 -0.03430984020456865 -0.2354 0.5794905827756759 0.5794884612980651 8.422407406782906e-07 -0.034323242460812545 -0.2355 0.5795194964266078 0.579517359410742 8.328052307216005e-07 -0.034336643319540706 -0.23560000000000003 0.579548405538302 0.5795462531489949 8.232325277024444e-07 -0.034350042780353286 -0.23570000000000002 0.5795773101093432 0.5795751425138489 8.135240652518139e-07 -0.0343634408428507 -0.2358 0.5796062101383286 0.579604027506317 8.036812986778052e-07 -0.034376837506633444 -0.2359 0.5796351056238687 0.5796329081274001 7.937057051321528e-07 -0.0343902327713024 -0.236 0.579663996564587 0.5796617843780866 7.83598782805317e-07 -0.03440362663645852 -0.23610000000000003 0.5796928829591207 0.5796906562593527 7.733620512595518e-07 -0.034417019101703084 -0.23620000000000002 0.5797217648061201 0.5797195237721611 7.629970508182815e-07 -0.03443041016663748 -0.2363 0.5797506421042499 0.5797483869174618 7.525053425105899e-07 -0.03444379983086334 -0.2364 0.5797795148521881 0.5797772456961918 7.418885079324422e-07 -0.034457188093982585 -0.2365 0.5798083830486274 0.5798061001092748 7.31148148941374e-07 -0.03447057495559726 -0.23660000000000003 0.5798372466922743 0.5798349501576207 7.202858871568907e-07 -0.03448396041530962 -0.23670000000000002 0.5798661057818504 0.5798637958421257 7.093033640714896e-07 -0.034497344472722194 -0.2368 0.5798949603160912 0.5798926371636723 6.982022406343269e-07 -0.03451072712743769 -0.2369 0.579923810293748 0.579921474123129 6.869841970014168e-07 -0.034524108379059025 -0.237 0.5799526557135861 0.5799503067213497 6.756509324523652e-07 -0.03453748822718933 -0.23710000000000003 0.5799814965743869 0.5799791349591744 6.642041648630137e-07 -0.03455086667143196 -0.23720000000000002 0.5800103328749464 0.5800079588374278 6.526456306499284e-07 -0.03456424371139048 -0.2373 0.5800391646140769 0.5800367783569208 6.409770845761109e-07 -0.03457761934666866 -0.2374 0.5800679917906058 0.5800655935184484 6.292002991958867e-07 -0.03459099357687049 -0.2375 0.5800968144033766 0.5800944043227911 6.173170648549053e-07 -0.03460436640160016 -0.23760000000000003 0.5801256324512487 0.5801232107707142 6.053291892460511e-07 -0.034617737820462076 -0.23770000000000002 0.5801544459330978 0.5801520128629674 5.932384972429094e-07 -0.03463110783306089 -0.2378 0.5801832548478161 0.5801808106002848 5.810468307054784e-07 -0.034644476439001426 -0.2379 0.5802120591943118 0.5802096039833852 5.687560479805676e-07 -0.03465784363788875 -0.238 0.5802408589715101 0.580238393012971 5.563680237630209e-07 -0.0346712094293281 -0.23810000000000003 0.580269654178353 0.580267177689729 5.438846487904048e-07 -0.03468457381292496 -0.23820000000000002 0.580298444813799 0.58029595801433 5.31307829482186e-07 -0.03469793678828503 -0.2383 0.5803272308768244 0.580324733987428 5.186394878842204e-07 -0.034711298355014235 -0.2384 0.5803560123664221 0.5803535056096608 5.05881561002619e-07 -0.03472465851271866 -0.2385 0.5803847892816028 0.5803822728816497 4.930360008870149e-07 -0.03473801726100464 -0.23860000000000003 0.580413561621394 0.5804110358039993 4.801047742142295e-07 -0.034751374599478725 -0.23870000000000002 0.5804423293848414 0.5804397943772974 4.670898617331609e-07 -0.03476473052774768 -0.2388 0.5804710925710087 0.5804685486021149 4.539932582786621e-07 -0.034778085045418475 -0.2389 0.5804998511789765 0.5804972984790053 4.408169724523514e-07 -0.03479143815209828 -0.239 0.5805286052078443 0.5805260440085049 4.275630261507679e-07 -0.034804789847394484 -0.23910000000000003 0.5805573546567294 0.5805547851911332 4.142334542461823e-07 -0.03481814013091472 -0.23920000000000002 0.5805860995247673 0.5805835220273915 4.008303045449635e-07 -0.03483148900226677 -0.2393 0.5806148398111118 0.580612254517764 3.8735563719083377e-07 -0.03484483646105871 -0.2394 0.5806435755149354 0.5806409826627174 3.7381152437343523e-07 -0.03485818250689878 -0.2395 0.5806723066354291 0.5806697064627001 3.602000502450631e-07 -0.03487152713939545 -0.23960000000000004 0.5807010331718023 0.5806984259181426 3.4652331037943185e-07 -0.03488487035815737 -0.23970000000000002 0.5807297551232837 0.5807271410294581 3.3278341156350866e-07 -0.03489821216279345 -0.2398 0.5807584724891205 0.5807558517970406 3.1898247135342395e-07 -0.03491155255291278 -0.2399 0.5807871852685791 0.5807845582212668 3.051226178663047e-07 -0.03492489152812469 -0.24 0.5808158934609448 0.5808132603024948 2.912059893778185e-07 -0.034938229088038696 -0.24010000000000004 0.5808445970655225 0.5808419580410641 2.7723473414176247e-07 -0.03495156523226455 -0.24020000000000002 0.5808732960816361 0.5808706514372955 2.632110098210738e-07 -0.03496489996041221 -0.2403 0.5809019905086289 0.5808993404914922 2.491369833629298e-07 -0.03497823327209184 -0.2404 0.5809306803458634 0.5809280252039375 2.3501483051302507e-07 -0.03499156516691383 -0.2405 0.5809593655927222 0.580956705574897 2.2084673562128287e-07 -0.035004895644488776 -0.24060000000000004 0.580988046248607 0.5809853816046164 2.066348911561322e-07 -0.03501822470442747 -0.24070000000000003 0.5810167223129397 0.5810140532933237 1.9238149752409672e-07 -0.035031552346340984 -0.24080000000000001 0.5810453937851614 0.5810427206412266 1.780887626187666e-07 -0.0350448785698405 -0.2409 0.5810740606647333 0.5810713836485147 1.63758901529365e-07 -0.0350582033745375 -0.241 0.5811027229511369 0.5811000423153583 1.4939413615217e-07 -0.03507152676004365 -0.24110000000000004 0.581131380643873 0.5811286966419082 1.3499669487132548e-07 -0.03508484872597084 -0.24120000000000003 0.5811600337424628 0.5811573466282962 1.205688122327131e-07 -0.03509816927193112 -0.24130000000000001 0.5811886822464477 0.5811859922746344 1.0611272861782428e-07 -0.035111488397536826 -0.2414 0.581217326155389 0.5812146335810162 9.163068979967104e-08 -0.03512480610240048 -0.2415 0.5812459654688684 0.5812432705475153 7.712494666523018e-08 -0.035138122386134805 -0.2416 0.5812746001864878 0.5812719031741855 6.25977548823764e-08 -0.03515143724835278 -0.24170000000000003 0.5813032303078692 0.5813005314610615 4.805137450436536e-08 -0.03516475068866751 -0.24180000000000001 0.5813318558326552 0.5813291554081585 3.3488069640236207e-08 -0.03517806270669243 -0.2419 0.5813604767605086 0.5813577750154719 1.891010811133631e-08 -0.035191373302041085 -0.242 0.5813890930911129 0.5813863902829774 4.3197610696821265e-09 -0.035204682474327294 -0.2421 0.5814177048241717 0.5814150012106314 -1.0280697343781342e-08 -0.03521799022316509 -0.24220000000000003 0.5814463119594093 0.5814436077983701 -2.488899033224745e-08 -0.03523129654816869 -0.24230000000000002 0.5814749144965708 0.5814722100461103 -3.9502838827289166e-08 -0.035244601448952556 -0.2424 0.5815035124354211 0.5815008079537488 -5.411996182984064e-08 -0.03525790492513132 -0.2425 0.5815321057757462 0.5815294015211627 -6.873807677438074e-08 -0.035271206976319865 -0.2426 0.5815606945173527 0.5815579907482097 -8.335489987999767e-08 -0.035284507602133294 -0.24270000000000003 0.5815892786600674 0.5815865756347272 -9.796814651012731e-08 -0.03529780680218688 -0.24280000000000002 0.5816178582037382 0.5816151561805327 -1.125755315304483e-07 -0.035311104576096174 -0.2429 0.5816464331482332 0.5816437323854242 -1.2717476966656038e-07 -0.03532440092347688 -0.243 0.5816750034934415 0.5816723042491799 -1.417635758609037e-07 -0.03533769584394495 -0.2431 0.5817035692392724 0.5817008717715578 -1.5633966561623414e-07 -0.03535098933711652 -0.24320000000000003 0.5817321303856561 0.5817294349522962 -1.7090075540848737e-07 -0.03536428140260799 -0.24330000000000002 0.5817606869325435 0.5817579937911138 -1.8544456297994727e-07 -0.035377572040035936 -0.2434 0.5817892388799056 0.5817865482877091 -1.9996880772782388e-07 -0.035390861249017164 -0.2435 0.5818177862277351 0.5818150984417614 -2.144712110546676e-07 -0.035404149029168684 -0.2436 0.5818463289760439 0.581843644252929 -2.289494967500083e-07 -0.03541743538010774 -0.24370000000000003 0.5818748671248655 0.5818721857208516 -2.434013913060751e-07 -0.035430720301451744 -0.24380000000000002 0.5819034006742534 0.5819007228451487 -2.5782462433759923e-07 -0.035444003792818375 -0.2439 0.5819319296242818 0.5819292556254198 -2.722169288871257e-07 -0.03545728585382548 -0.244 0.5819604539750455 0.581957784061245 -2.865760417788965e-07 -0.035470566484091165 -0.2441 0.5819889737266597 0.5819863081521847 -3.0089970397967347e-07 -0.03548384568323374 -0.24420000000000003 0.58201748887926 0.5820148278977791 -3.1518566108446056e-07 -0.03549712345087169 -0.24430000000000002 0.5820459994330027 0.5820433432975499 -3.294316634205874e-07 -0.035510399786623785 -0.2444 0.582074505388064 0.582071854350998 -3.43635466651393e-07 -0.03552367469010893 -0.2445 0.5821030067446408 0.5821003610576053 -3.577948319288815e-07 -0.03553694816094632 -0.2446 0.5821315035029498 0.5821288634168342 -3.719075264557725e-07 -0.03555022019875528 -0.24470000000000003 0.5821599956632286 0.5821573614281278 -3.85971323624279e-07 -0.03556349080315542 -0.24480000000000002 0.5821884832257347 0.5821858550909095 -3.999840035295854e-07 -0.03557675997376655 -0.2449 0.5822169661907454 0.5822143444045834 -4.139433532196479e-07 -0.03559002771020868 -0.245 0.5822454445585583 0.5822428293685344 -4.2784716720867255e-07 -0.035603294012102035 -0.2451 0.5822739183294913 0.5822713099821282 -4.4169324756038186e-07 -0.035616558879067055 -0.24520000000000003 0.5823023875038816 0.5822997862447111 -4.554794044570043e-07 -0.03562982231072441 -0.24530000000000002 0.5823308520820873 0.5823282581556105 -4.6920345656009665e-07 -0.03564308430669496 -0.2454 0.5823593120644851 0.5823567257141349 -4.828632311076886e-07 -0.03565634486659982 -0.2455 0.5823877674514725 0.5823851889195735 -4.964565645249053e-07 -0.03566960399006027 -0.2456 0.5824162182434656 0.582413647771197 -5.099813026876454e-07 -0.03568286167669783 -0.24570000000000003 0.5824446644409009 0.5824421022682567 -5.234353012834037e-07 -0.03569611792613424 -0.24580000000000002 0.5824731060442343 0.5824705524099858 -5.368164260749486e-07 -0.03570937273799143 -0.2459 0.5825015430539409 0.5824989981955987 -5.501225531362453e-07 -0.03572262611189158 -0.246 0.5825299754705149 0.5825274396242913 -5.633515696851221e-07 -0.03573587804745708 -0.2461 0.5825584032944703 0.5825558766952408 -5.765013738612268e-07 -0.035749128544310484 -0.24620000000000003 0.5825868265263399 0.582584309407606 -5.895698753366485e-07 -0.03576237760207461 -0.24630000000000002 0.5826152451666755 0.5826127377605278 -6.025549955379628e-07 -0.0357756252203725 -0.2464 0.5826436592160479 0.5826411617531285 -6.154546681180761e-07 -0.03578887139882735 -0.2465 0.5826720686750464 0.5826695813845131 -6.282668391088819e-07 -0.03580211613706262 -0.2466 0.5827004735442799 0.5826979966537676 -6.409894675318828e-07 -0.03581535943470198 -0.24670000000000003 0.5827288738243751 0.5827264075599614 -6.536205253704352e-07 -0.03582860129136935 -0.24680000000000002 0.5827572695159777 0.5827548141021451 -6.66157998263639e-07 -0.03584184170668878 -0.2469 0.5827856606197515 0.5827832162793518 -6.785998853953146e-07 -0.03585508068028458 -0.247 0.5828140471363784 0.5828116140905978 -6.909442002711597e-07 -0.03586831821178129 -0.24710000000000001 0.5828424290665589 0.5828400075348814 -7.031889706354821e-07 -0.035881554300803635 -0.24720000000000003 0.5828708064110112 0.5828683966111838 -7.153322392206007e-07 -0.035894788946976564 -0.24730000000000002 0.5828991791704715 0.5828967813184692 -7.27372063746845e-07 -0.03590802214992527 -0.2474 0.5829275473456941 0.582925161655685 -7.393065170335777e-07 -0.03592125390927512 -0.2475 0.5829559109374503 0.5829535376217609 -7.511336880539066e-07 -0.035934484224651723 -0.24760000000000001 0.582984269946529 0.582981909215611 -7.628516815738617e-07 -0.03594771309568088 -0.2477 0.583012624373737 0.583010276436132 -7.744586185964852e-07 -0.03596094052198864 -0.24780000000000002 0.583040974219898 0.5830386392822046 -7.859526368614311e-07 -0.03597416650320121 -0.2479 0.5830693194858525 0.5830669977526929 -7.973318907894544e-07 -0.035987391038945084 -0.248 0.5830976601724582 0.5830953518464448 -8.085945524816118e-07 -0.03600061412884692 -0.24810000000000001 0.5831259962805899 0.5831237015622925 -8.197388110253723e-07 -0.03601383577253361 -0.2482 0.5831543278111386 0.5831520468990523 -8.307628737713735e-07 -0.03602705596963226 -0.24830000000000002 0.5831826547650116 0.5831803878555247 -8.416649658615771e-07 -0.03604027471977019 -0.2484 0.5832109771431329 0.5832087244304947 -8.524433308954027e-07 -0.03605349202257493 -0.2485 0.5832392949464426 0.5832370566227316 -8.630962312905499e-07 -0.03606670787767422 -0.24860000000000002 0.5832676081758965 0.5832653844309899 -8.736219483940211e-07 -0.036079922284696045 -0.2487 0.5832959168324667 0.5832937078540091 -8.840187826486545e-07 -0.03609313524326856 -0.24880000000000002 0.5833242209171406 0.5833220268905136 -8.942850541204805e-07 -0.03610634675302021 -0.2489 0.5833525204309213 0.583350341539213 -9.044191026374993e-07 -0.036119556813579555 -0.249 0.583380815374827 0.5833786517988023 -9.144192882615254e-07 -0.03613276542457544 -0.24910000000000002 0.5834091057498911 0.5834069576679625 -9.242839910938994e-07 -0.03614597258563689 -0.2492 0.5834373915571622 0.5834352591453601 -9.340116121081543e-07 -0.03615917829639318 -0.24930000000000002 0.5834656727977034 0.5834635562296479 -9.436005729834829e-07 -0.03617238255647378 -0.2494 0.5834939494725924 0.583491848919464 -9.530493167708709e-07 -0.036185585365508345 -0.2495 0.5835222215829217 0.5835201372134343 -9.62356307532275e-07 -0.03619878672312681 -0.24960000000000002 0.5835504891297972 0.58354842111017 -9.715200314230898e-07 -0.03621198662895926 -0.2497 0.5835787521143401 0.5835767006082696 -9.805389959705035e-07 -0.03622518508263606 -0.24980000000000002 0.5836070105376844 0.5836049757063184 -9.894117312947426e-07 -0.03623838208378776 -0.2499 0.5836352644009779 0.5836332464028886 -9.981367898037607e-07 -0.03625157763204508 -0.25 0.5836635137053824 0.5836615126965403 -1.006712746332017e-06 -0.03626477172703906 -0.25010000000000004 0.5836917584520724 0.5836897745858206 -1.0151381987788533e-06 -0.03627796436840086 -0.25020000000000003 0.5837199986422358 0.5837180320692644 -1.0234117681084953e-06 -0.036291155555761866 -0.2503 0.5837482342770732 0.5837462851453947 -1.0315320984888299e-06 -0.03630434528875377 -0.2504 0.5837764653577979 0.5837745338127224 -1.0394978577077385e-06 -0.03631753356700838 -0.2505 0.5838046918856358 0.5838027780697468 -1.0473077373951423e-06 -0.036330720390157736 -0.25060000000000004 0.5838329138618246 0.5838310179149555 -1.054960453328313e-06 -0.0363439057578341 -0.25070000000000003 0.5838611312876141 0.5838592533468253 -1.0624547450155397e-06 -0.03635708966966996 -0.2508 0.5838893441642666 0.5838874843638218 -1.0697893769451294e-06 -0.03637027212529807 -0.2509 0.5839175524930553 0.5839157109643996 -1.0769631378360067e-06 -0.03638345312435131 -0.251 0.5839457562752648 0.5839439331470028 -1.0839748411928252e-06 -0.03639663266646279 -0.25110000000000005 0.5839739555121914 0.5839721509100652 -1.0908233260276123e-06 -0.036409810751265904 -0.25120000000000003 0.5840021502051419 0.5840003642520104 -1.097507456193636e-06 -0.03642298737839422 -0.2513 0.5840303403554338 0.5840285731712517 -1.1040261211348046e-06 -0.03643616254748148 -0.2514 0.5840585259643952 0.584056777666193 -1.1103782359134229e-06 -0.03644933625816169 -0.2515 0.5840867070333644 0.5840849777352286 -1.116562741265703e-06 -0.036462508510069054 -0.25160000000000005 0.5841148835636899 0.5841131733767437 -1.1225786040180985e-06 -0.03647567930283802 -0.25170000000000003 0.58414305555673 0.5841413645891143 -1.1284248170873035e-06 -0.03648884863610321 -0.2518 0.5841712230138527 0.5841695513707075 -1.1341004001463872e-06 -0.036502016509499524 -0.2519 0.5841993859364351 0.584197733719882 -1.1396043986255933e-06 -0.036515182922662 -0.252 0.5842275443258633 0.5842259116349882 -1.144935885100118e-06 -0.03652834787522596 -0.25210000000000005 0.5842556981835325 0.584254085114368 -1.150093959123577e-06 -0.03654151136682684 -0.25220000000000004 0.5842838475108464 0.5842822541563557 -1.1550777465618722e-06 -0.03655467339710041 -0.2523 0.5843119923092174 0.5843104187592778 -1.1598864013140364e-06 -0.03656783396568257 -0.2524 0.5843401325800661 0.5843385789214541 -1.1645191039244551e-06 -0.036580993072209564 -0.2525 0.5843682683248204 0.5843667346411962 -1.1689750626930895e-06 -0.03659415071631764 -0.25260000000000005 0.5843963995449165 0.5843948859168094 -1.173253513175876e-06 -0.03660730689764348 -0.25270000000000004 0.584424526241798 0.5844230327465924 -1.1773537190173933e-06 -0.03662046161582385 -0.2528 0.5844526484169152 0.584451175128837 -1.1812749714512627e-06 -0.03663361487049576 -0.2529 0.5844807660717262 0.5844793130618292 -1.185016589855259e-06 -0.03664676666129648 -0.253 0.5845088792076948 0.5845074465438489 -1.1885779214737546e-06 -0.03665991698786341 -0.25310000000000005 0.5845369878262918 0.58453557557317 -1.1919583419173208e-06 -0.0366730658498342 -0.25320000000000004 0.5845650919289941 0.584563700148062 -1.1951572551072154e-06 -0.03668621324684675 -0.2533 0.5845931915172846 0.584591820266788 -1.1981740934419172e-06 -0.03669935917853916 -0.2534 0.5846212865926521 0.5846199359276072 -1.2010083177971254e-06 -0.03671250364454975 -0.2535 0.5846493771565906 0.584648047128773 -1.2036594176922932e-06 -0.03672564664451705 -0.25360000000000005 0.5846774632105993 0.5846761538685356 -1.206126911235117e-06 -0.0367387881780798 -0.25370000000000004 0.584705544756182 0.58470425614514 -1.2084103457321582e-06 -0.03675192824487692 -0.2538 0.584733621794848 0.584732353956828 -1.2105092970782216e-06 -0.03676506684454764 -0.2539 0.5847616943281102 0.5847604473018375 -1.212423370255955e-06 -0.03677820397673135 -0.254 0.5847897623574865 0.5847885361784027 -1.2141521992803384e-06 -0.03679133964106763 -0.25410000000000005 0.5848178258844976 0.5848166205847551 -1.2156954475872617e-06 -0.036804473837196296 -0.25420000000000004 0.5848458849106688 0.5848447005191231 -1.2170528075339249e-06 -0.036817606564757396 -0.2543 0.5848739394375285 0.5848727759797323 -1.2182240008429268e-06 -0.03683073782339117 -0.2544 0.5849019894666083 0.5849008469648065 -1.219208778491243e-06 -0.03684386761273813 -0.2545 0.5849300349994424 0.5849289134725667 -1.220006921098804e-06 -0.03685699593243894 -0.25460000000000005 0.5849580760375679 0.5849569755012326 -1.2206182385954278e-06 -0.03687012278213451 -0.25470000000000004 0.5849861125825239 0.584985033049022 -1.2210425703318428e-06 -0.036883248161465945 -0.2548 0.585014144635852 0.5850130861141516 -1.221279785301732e-06 -0.03689637207007459 -0.2549 0.5850421721990953 0.5850411346948367 -1.2213297821417335e-06 -0.036909494507601975 -0.255 0.5850701952737987 0.5850691787892923 -1.2211924886318393e-06 -0.03692261547368993 -0.25510000000000005 0.5850982138615083 0.5850972183957325 -1.220867862750108e-06 -0.03693573496798037 -0.25520000000000004 0.585126227963771 0.5851252535123712 -1.2203558920620416e-06 -0.03694885299011552 -0.2553 0.5851542375821351 0.5851532841374221 -1.2196565933875192e-06 -0.03696196953973779 -0.2554 0.5851822427181488 0.5851813102690999 -1.2187700136889745e-06 -0.03697508461648986 -0.2555 0.5852102433733606 0.5852093319056189 -1.2176962291277071e-06 -0.0369881982200145 -0.25560000000000005 0.5852382395493189 0.5852373490451948 -1.2164353462296162e-06 -0.03700131034995481 -0.25570000000000004 0.5852662312475723 0.5852653616860444 -1.2149875006084443e-06 -0.0370144210059541 -0.2558 0.5852942184696682 0.5852933698263849 -1.2133528579649777e-06 -0.03702753018765579 -0.2559 0.585322201217154 0.5853213734644367 -1.2115316135319354e-06 -0.03704063789470368 -0.256 0.5853501794915753 0.5853493725984202 -1.2095239920184575e-06 -0.037053744126741665 -0.25610000000000005 0.5853781532944766 0.5853773672265593 -1.207330248165217e-06 -0.03706684888341388 -0.2562 0.5854061226274008 0.5854053573470799 -1.204950666078286e-06 -0.03707995216436469 -0.25630000000000003 0.5854340874918885 0.5854333429582101 -1.2023855593401578e-06 -0.03709305396923868 -0.2564 0.5854620478894792 0.5854613240581816 -1.1996352713428138e-06 -0.03710615429768064 -0.2565 0.5854900038217088 0.5854893006452289 -1.1967001749546569e-06 -0.03711925314933561 -0.25660000000000005 0.5855179552901111 0.5855172727175897 -1.193580672465e-06 -0.037132350523848806 -0.2567 0.5855459022962172 0.585545240273506 -1.1902771955285552e-06 -0.037145446420865647 -0.25680000000000003 0.5855738448415544 0.5855732033112232 -1.1867902053319668e-06 -0.037158540840031784 -0.2569 0.5856017829276471 0.5856011618289911 -1.1831201921497225e-06 -0.037171633780993134 -0.257 0.5856297165560154 0.5856291158250643 -1.1792676757327314e-06 -0.03718472524339577 -0.2571 0.585657645728176 0.5856570652977017 -1.1752332049197456e-06 -0.03719781522688601 -0.2572 0.5856855704456411 0.5856850102451672 -1.1710173576928717e-06 -0.03721090373111035 -0.25730000000000003 0.5857134907099184 0.5857129506657304 -1.1666207409555263e-06 -0.03722399075571557 -0.2574 0.5857414065225107 0.5857408865576661 -1.162043990809991e-06 -0.03723707630034862 -0.2575 0.5857693178849158 0.5857688179192548 -1.1572877719467911e-06 -0.03725016036465664 -0.2576 0.5857972247986267 0.5857967447487835 -1.1523527778667386e-06 -0.03726324294828706 -0.2577 0.58582512726513 0.5858246670445453 -1.1472397309364446e-06 -0.037276324050887495 -0.25780000000000003 0.5858530252859072 0.5858525848048393 -1.141949382166274e-06 -0.037289403672105745 -0.2579 0.5858809188624334 0.5858804980279722 -1.136482510821768e-06 -0.03730248181158986 -0.258 0.5859088079961776 0.5859084067122576 -1.1308399244791545e-06 -0.037315558468988104 -0.2581 0.5859366926886019 0.5859363108560162 -1.1250224591918823e-06 -0.03732863364394893 -0.2582 0.5859645729411621 0.5859642104575763 -1.1190309791020425e-06 -0.03734170733612104 -0.25830000000000003 0.5859924487553063 0.5859921055152741 -1.1128663763848579e-06 -0.03735477954515336 -0.2584 0.586020320132476 0.5860199960274539 -1.1065295710821488e-06 -0.037367850270694995 -0.2585 0.5860481870741043 0.5860478819924685 -1.100021510880289e-06 -0.037380919512395284 -0.2586 0.5860760495816171 0.5860757634086787 -1.0933431711657171e-06 -0.03739398726990376 -0.2587 0.5861039076564318 0.5861036402744548 -1.0864955548306465e-06 -0.03740705354287023 -0.25880000000000003 0.586131761299958 0.5861315125881761 -1.0794796921342886e-06 -0.03742011833094468 -0.2589 0.5861596105135963 0.5861593803482307 -1.0722966405085632e-06 -0.03743318163377731 -0.259 0.5861874552987387 0.5861872435530168 -1.0649474842805429e-06 -0.03744624345101854 -0.2591 0.5862152956567679 0.5862151022009423 -1.0574333349222531e-06 -0.03745930378231903 -0.2592 0.5862431315890575 0.5862429562904248 -1.0497553304400498e-06 -0.037472362627329586 -0.25930000000000003 0.5862709630969716 0.5862708058198928 -1.0419146352080855e-06 -0.037485419985701346 -0.2594 0.5862987901818644 0.5862986507877848 -1.0339124402458655e-06 -0.03749847585708556 -0.2595 0.5863266128450801 0.5863264911925501 -1.025749962801914e-06 -0.03751153024113374 -0.2596 0.5863544310879529 0.5863543270326497 -1.0174284459374405e-06 -0.03752458313749763 -0.2597 0.5863822449118063 0.5863821583065548 -1.008949158581851e-06 -0.037537634545829146 -0.25980000000000003 0.5864100543179529 0.586409985012749 -1.0003133955049925e-06 -0.03755068446578044 -0.2599 0.5864378593076944 0.5864378071497269 -9.9152247670653e-07 -0.037563732897003904 -0.26 0.5864656598823218 0.5864656247159956 -9.825777475824804e-07 -0.03757677983915211 -0.2601 0.5864934560431143 0.5864934377100738 -9.734805783701006e-07 -0.037589825291877876 -0.2602 0.5865212477913394 0.586521246130493 -9.642323642866657e-07 -0.037602869254834206 -0.26030000000000003 0.586549035128253 0.5865490499757974 -9.548345253351798e-07 -0.037615911727674374 -0.2604 0.5865768180550986 0.5865768492445436 -9.452885056659976e-07 -0.03762895271005184 -0.2605 0.5866045965731078 0.5866046439353015 -9.355957739376475e-07 -0.03764199220162023 -0.2606 0.5866323706834993 0.5866324340466544 -9.257578224841634e-07 -0.03765503020203345 -0.2607 0.5866601403874793 0.5866602195771989 -9.157761675926412e-07 -0.03766806671094565 -0.26080000000000003 0.586687905686241 0.5866880005255453 -9.056523490036383e-07 -0.037681101728011104 -0.2609 0.5867156665809643 0.5867157768903177 -8.953879297723955e-07 -0.03769413525288437 -0.261 0.5867434230728161 0.5867435486701548 -8.849844960745479e-07 -0.037707167285220215 -0.2611 0.5867711751629494 0.5867713158637092 -8.744436568175473e-07 -0.03772019782467361 -0.2612 0.5867989228525035 0.5867990784696484 -8.637670435573952e-07 -0.03773322687089974 -0.26130000000000003 0.5868266661426036 0.5868268364866539 -8.529563101100646e-07 -0.037746254423554 -0.2614 0.5868544050343605 0.586854589913423 -8.420131323849667e-07 -0.03775928048229202 -0.2615 0.5868821395288712 0.5868823387486679 -8.309392080796396e-07 -0.03777230504676965 -0.2616 0.5869098696272177 0.5869100829911161 -8.197362564854593e-07 -0.03778532811664295 -0.2617 0.5869375953304674 0.5869378226395106 -8.084060181268171e-07 -0.0377983496915682 -0.26180000000000003 0.5869653166396724 0.5869655576926099 -7.96950254733364e-07 -0.037811369771201864 -0.2619 0.5869930335558702 0.586993288149189 -7.85370748573877e-07 -0.037824388355200696 -0.262 0.5870207460800821 0.5870210140080389 -7.736693025672814e-07 -0.037837405443221596 -0.2621 0.5870484542133146 0.5870487352679663 -7.61847739672028e-07 -0.0378504210349217 -0.2622 0.5870761579565581 0.5870764519277949 -7.499079029416045e-07 -0.03786343512995836 -0.26230000000000003 0.5871038573107874 0.5871041639863651 -7.37851654941668e-07 -0.0378764477279892 -0.2624 0.5871315522769609 0.5871318714425338 -7.256808776667789e-07 -0.03788945882867198 -0.2625 0.5871592428560205 0.5871595742951752 -7.133974721795777e-07 -0.0379024684316647 -0.2626 0.5871869290488922 0.5871872725431807 -7.010033583054742e-07 -0.0379154765366256 -0.2627 0.5872146108564853 0.5872149661854591 -6.885004742718248e-07 -0.03792848314321312 -0.26280000000000003 0.5872422882796919 0.5872426552209367 -6.758907765413991e-07 -0.03794148825108597 -0.2629 0.5872699613193874 0.5872703396485572 -6.631762393682905e-07 -0.03795449185990296 -0.263 0.5872976299764301 0.5872980194672826 -6.503588547424055e-07 -0.03796749396932322 -0.2631 0.5873252942516611 0.5873256946760925 -6.374406316678183e-07 -0.03798049457900605 -0.2632 0.5873529541459042 0.5873533652739855 -6.244235963015488e-07 -0.037993493688611005 -0.26330000000000003 0.587380609659965 0.5873810312599773 -6.113097912874288e-07 -0.038006491297797804 -0.2634 0.5874082607946318 0.5874086926331032 -5.981012757283466e-07 -0.038019487406226425 -0.2635 0.5874359075506752 0.5874363493924164 -5.848001245201129e-07 -0.03803248201355702 -0.2636 0.5874635499288473 0.5874640015369892 -5.714084283514609e-07 -0.038045475119450015 -0.2637 0.5874911879298821 0.5874916490659128 -5.579282932877128e-07 -0.038058466723566 -0.26380000000000003 0.5875188215544958 0.5875192919782978 -5.443618403822015e-07 -0.03807145682556584 -0.2639 0.5875464508033855 0.5875469302732733 -5.307112051627927e-07 -0.038084445425110566 -0.264 0.5875740756772304 0.5875745639499885 -5.169785377151515e-07 -0.03809743252186146 -0.2641 0.5876016961766901 0.5876021930076114 -5.031660021276307e-07 -0.03811041811547999 -0.2642 0.5876293123024058 0.5876298174453303 -4.892757760888156e-07 -0.038123402205627856 -0.26430000000000003 0.5876569240549998 0.5876574372623524 -4.753100506377228e-07 -0.03813638479196697 -0.2644 0.5876845314350752 0.5876850524579056 -4.6127102980297874e-07 -0.03814936587415947 -0.2645 0.5877121344432159 0.587712663031237 -4.471609300893409e-07 -0.038162345451867724 -0.2646 0.5877397330799864 0.5877402689816147 -4.329819805470869e-07 -0.03817532352475429 -0.2647 0.5877673273459317 0.587767870308326 -4.187364221058809e-07 -0.03818830009248195 -0.26480000000000004 0.5877949172415773 0.5877954670106793 -4.044265072278286e-07 -0.03820127515471369 -0.2649 0.5878225027674291 0.5878230590880029 -3.9005449953277704e-07 -0.03821424871111277 -0.265 0.587850083923973 0.5878506465396461 -3.756226735762702e-07 -0.038227220761342606 -0.2651 0.5878776607116754 0.5878782293649784 -3.611333145026041e-07 -0.03824019130506683 -0.2652 0.587905233130982 0.5879058075633903 -3.4658871754522647e-07 -0.03825316034194934 -0.26530000000000004 0.5879328011823195 0.5879333811342928 -3.3199118769366986e-07 -0.038266127871654225 -0.2654 0.5879603648660936 0.5879609500771183 -3.1734303940211817e-07 -0.03827909389384579 -0.2655 0.5879879241826902 0.58798851439132 -3.0264659629797297e-07 -0.038292058408188556 -0.2656 0.5880154791324744 0.5880160740763719 -2.879041905295976e-07 -0.03830502141434726 -0.2657 0.588043029715791 0.5880436291317699 -2.731181626344781e-07 -0.03831798291198687 -0.26580000000000004 0.5880705759329647 0.5880711795570299 -2.5829086114370625e-07 -0.03833094290077253 -0.2659 0.5880981177842991 0.5880987253516904 -2.434246421309516e-07 -0.03834390138036967 -0.266 0.5881256552700775 0.5881262665153106 -2.285218689002111e-07 -0.03835685835044387 -0.2661 0.5881531883905625 0.5881538030474713 -2.1358491155559767e-07 -0.03836981381066097 -0.2662 0.5881807171459955 0.588181334947775 -1.986161467168457e-07 -0.03838276776068701 -0.26630000000000004 0.5882082415365978 0.5882088622158457 -1.8361795700583272e-07 -0.038395720200188256 -0.2664 0.588235761562569 0.5882363848513289 -1.6859273087310722e-07 -0.03840867112883119 -0.2665 0.5882632772240881 0.5882639028538917 -1.535428619386936e-07 -0.03842162054628248 -0.2666 0.5882907885213132 0.5882914162232238 -1.3847074888106992e-07 -0.03843456845220908 -0.2667 0.5883182954543812 0.5883189249590354 -1.2337879486470915e-07 -0.03844751484627808 -0.26680000000000004 0.5883457980234079 0.5883464290610595 -1.0826940725905398e-07 -0.038460459728156864 -0.2669 0.5883732962284878 0.5883739285290508 -9.31449972464693e-08 -0.03847340309751296 -0.267 0.5884007900696946 0.5884014233627858 -7.80079793660099e-08 -0.03848634495401418 -0.2671 0.5884282795470803 0.5884289135620628 -6.286077122198697e-08 -0.03849928529732849 -0.2672 0.5884557646606764 0.5884563991267028 -4.770579303380734e-08 -0.03851222412712415 -0.26730000000000004 0.588483245410492 0.588483880056548 -3.254546727254892e-08 -0.038525161443069555 -0.2674 0.588510721796516 0.5885113563514628 -1.7382218270864738e-08 -0.03853809724483338 -0.2675 0.5885381938187153 0.5885388280113342 -2.2184718302849238e-09 -0.03855103153208449 -0.2676 0.5885656614770357 0.5885662950360708 1.2943345159555086e-08 -0.03856396430449196 -0.2677 0.5885931247714016 0.5885937574256035 2.810080511686519e-08 -0.03857689556172508 -0.26780000000000004 0.588620583701716 0.5886212151798852 4.3251480149122945e-08 -0.038589825303453416 -0.2679 0.5886480382678605 0.5886486682988907 5.83929424501084e-08 -0.03860275352934667 -0.268 0.5886754884696955 0.5886761167826176 7.352276469585473e-08 -0.03861568023907479 -0.2681 0.58870293430706 0.5887035606310848 8.863852039853182e-08 -0.03862860543230794 -0.2682 0.5887303757797712 0.588730999844334 1.037377843592091e-07 -0.038641529108716544 -0.26830000000000004 0.5887578128876256 0.5887584344224286 1.1881813298877941e-07 -0.038654451267971186 -0.2684 0.588785245630398 0.5887858643654542 1.3387714474510926e-07 -0.038667371909742704 -0.2685 0.5888126740078417 0.5888132896735188 1.489124005354947e-07 -0.03868029103370213 -0.2686 0.5888400980196891 0.5888407103467519 1.6392148405319773e-07 -0.03869320863952075 -0.2687 0.5888675176656506 0.5888681263853054 1.7890198217990205e-07 -0.038706124726869996 -0.26880000000000004 0.5888949329454161 0.588895537789353 1.93851485419394e-07 -0.03871903929542158 -0.26890000000000003 0.5889223438586538 0.5889229445590909 2.0876758826532393e-07 -0.03873195234484743 -0.269 0.5889497504050109 0.5889503466947367 2.2364788952039527e-07 -0.038744863874819645 -0.2691 0.5889771525841131 0.58897774419653 2.384899928237205e-07 -0.038757773885010595 -0.2692 0.5890045503955653 0.5890051370647327 2.5329150687286583e-07 -0.03877068237509283 -0.2693 0.5890319438389511 0.5890325252996281 2.680500459928403e-07 -0.03878358934473913 -0.26940000000000003 0.5890593329138331 0.5890599089015215 2.8276323035814066e-07 -0.0387964947936225 -0.2695 0.589086717619753 0.58908728787074 2.9742868647153475e-07 -0.038809398721416165 -0.2696 0.589114097956231 0.5891146622076323 3.1204404749018977e-07 -0.038822301127793536 -0.2697 0.5891414739227673 0.5891420319125688 3.266069537044558e-07 -0.03883520201242827 -0.2698 0.5891688455188405 0.5891693969859413 3.411150528431772e-07 -0.038848101374994254 -0.26990000000000003 0.5891962127439088 0.5891967574281634 3.555660003928818e-07 -0.03886099921516555 -0.27 0.5892235755974095 0.5892241132396698 3.6995746022228104e-07 -0.03887389553261646 -0.2701 0.5892509340787592 0.589251464420917 3.8428710459614823e-07 -0.038886790327021525 -0.2702 0.5892782881873544 0.5892788109723828 3.9855261491084093e-07 -0.03889968359805546 -0.2703 0.5893056379225704 0.5893061528945658 4.1275168188859013e-07 -0.03891257534539322 -0.27040000000000003 0.5893329832837627 0.5893334901879861 4.268820059660783e-07 -0.03892546556870999 -0.2705 0.5893603242702662 0.5893608228531848 4.4094129758587286e-07 -0.03893835426768116 -0.2706 0.5893876608813955 0.589388150890724 4.549272777931712e-07 -0.038951241441982344 -0.2707 0.5894149931164451 0.5894154743011867 4.688376785272341e-07 -0.03896412709128935 -0.2708 0.5894423209746893 0.5894427930851766 4.826702428295526e-07 -0.03897701121527823 -0.27090000000000003 0.589469644455383 0.589470107243318 4.964227253156928e-07 -0.03898989381362525 -0.271 0.5894969635577603 0.5894974167762563 5.100928926610182e-07 -0.03900277488600686 -0.2711 0.5895242782810365 0.5895247216846571 5.236785238227348e-07 -0.039015654432099804 -0.2712 0.5895515886244064 0.5895520219692061 5.371774104701021e-07 -0.039028532451580944 -0.2713 0.5895788945870457 0.5895793176306096 5.50587357261989e-07 -0.03904140894412741 -0.27140000000000003 0.5896061961681109 0.5896066086695941 5.639061823048408e-07 -0.03905428390941658 -0.2715 0.5896334933667389 0.5896338950869064 5.77131717416357e-07 -0.03906715734712602 -0.2716 0.5896607861820471 0.5896611768833125 5.902618086806033e-07 -0.03908002925693347 -0.2717 0.5896880746131341 0.5896884540595987 6.032943165312776e-07 -0.03909289963851696 -0.2718 0.5897153586590798 0.5897157266165711 6.162271162513111e-07 -0.03910576849155471 -0.27190000000000003 0.589742638318945 0.589742994555055 6.290580983614458e-07 -0.03911863581572516 -0.272 0.589769913591772 0.5897702578758954 6.41785168731257e-07 -0.03913150161070695 -0.2721 0.5897971844765842 0.5897975165799565 6.544062493007985e-07 -0.03914436587617895 -0.2722 0.5898244509723871 0.5898247706681217 6.669192780806021e-07 -0.03915722861182026 -0.2723 0.5898517130781672 0.5898520201412931 6.793222097900564e-07 -0.03917008981731016 -0.27240000000000003 0.5898789707928935 0.5898792650003922 6.916130159684286e-07 -0.0391829494923282 -0.2725 0.5899062241155169 0.5899065052463587 7.037896853079317e-07 -0.039195807636554086 -0.2726 0.5899334730449703 0.589933740880151 7.158502240978137e-07 -0.03920866424966779 -0.2727 0.5899607175801692 0.5899609719027461 7.277926566406911e-07 -0.039221519331349486 -0.2728 0.5899879577200116 0.5899881983151393 7.396150253635714e-07 -0.039234372881279594 -0.27290000000000003 0.5900151934633774 0.5900154201183434 7.513153909843862e-07 -0.03924722489913868 -0.273 0.5900424248091303 0.59004263731339 7.628918335667034e-07 -0.0392600753846076 -0.2731 0.5900696517561166 0.5900698499013277 7.743424521311493e-07 -0.03927292433736737 -0.2732 0.5900968743031654 0.5900970578832231 7.856653650717416e-07 -0.0392857717570993 -0.2733 0.5901240924490898 0.5901242612601603 7.968587107665126e-07 -0.039298617643484836 -0.27340000000000003 0.5901513061926857 0.5901514600332403 8.079206476330203e-07 -0.03931146199620569 -0.2735 0.5901785155327333 0.5901786542035813 8.188493545724373e-07 -0.039324304814943783 -0.2736 0.5902057204679959 0.5902058437723184 8.296430311083292e-07 -0.03933714609938122 -0.2737 0.5902329209972215 0.5902330287406036 8.402998978862541e-07 -0.03934998584920039 -0.2738 0.5902601171191422 0.590260209109605 8.508181969790751e-07 -0.03936282406408384 -0.27390000000000003 0.590287308832474 0.590287384880507 8.611961918592037e-07 -0.03937566074371432 -0.274 0.5903144961359181 0.5903145560545109 8.714321680924897e-07 -0.03938849588777487 -0.2741 0.5903416790281603 0.5903417226328332 8.815244333659766e-07 -0.0394013294959487 -0.2742 0.5903688575078714 0.5903688846167067 8.914713179042355e-07 -0.03941416156791928 -0.2743 0.5903960315737072 0.5903960420073789 9.012711747469204e-07 -0.03942699210337022 -0.27440000000000003 0.5904232012243091 0.5904231948061135 9.109223798320354e-07 -0.039439821101985406 -0.2745 0.590450366458304 0.590450343014189 9.204233325232902e-07 -0.03945264856344893 -0.2746 0.5904775272743048 0.5904774866328988 9.297724557211229e-07 -0.039465474487445126 -0.2747 0.5905046836709101 0.5905046256635511 9.389681961957663e-07 -0.039478298873658516 -0.2748 0.5905318356467051 0.5905317601074686 9.480090248370487e-07 -0.039491121721773825 -0.27490000000000003 0.5905589832002606 0.5905588899659882 9.568934369597049e-07 -0.039503943031476 -0.275 0.5905861263301352 0.5905860152404608 9.656199525254205e-07 -0.039516762802450256 -0.2751 0.5906132650348734 0.5906131359322516 9.741871162538551e-07 -0.03952958103438195 -0.2752 0.5906403993130075 0.5906402520427392 9.825934981222417e-07 -0.03954239772695673 -0.2753 0.5906675291630565 0.5906673635733153 9.908376934208984e-07 -0.03955521287986039 -0.27540000000000003 0.5906946545835275 0.5906944705253854 9.989183231140508e-07 -0.039568026492779025 -0.2755 0.5907217755729152 0.5907215729003673 1.0068340337288095e-06 -0.03958083856539886 -0.2756 0.5907488921297019 0.5907486706996921 1.01458349829886e-06 -0.0395936490974064 -0.2757 0.5907760042523588 0.590775763924803 1.022165416059151e-06 -0.03960645808848834 -0.2758 0.590803111939345 0.5908028525771557 1.0295785125569168e-06 -0.039619265538331595 -0.27590000000000003 0.5908302151891085 0.590829936658218 1.0368215403733227e-06 -0.03963207144662334 -0.276 0.5908573140000865 0.5908570161694692 1.0438932786516197e-06 -0.03964487581305087 -0.2761 0.5908844083707048 0.5908840911124005 1.0507925340963453e-06 -0.03965767863730181 -0.2762 0.5909114982993792 0.5909111614885139 1.0575181407790346e-06 -0.039670479919063945 -0.2763 0.5909385837845147 0.5909382272993231 1.0640689601382203e-06 -0.03968327965802524 -0.27640000000000003 0.5909656648245065 0.5909652885463521 1.070443881479033e-06 -0.03969607785387395 -0.2765 0.59099274141774 0.5909923452311356 1.0766418221397345e-06 -0.03970887450629852 -0.2766 0.591019813562591 0.591019397355219 1.0826617275472294e-06 -0.039721669614987604 -0.2767 0.5910468812574255 0.5910464449201571 1.0885025715778873e-06 -0.03973446317963006 -0.2768 0.5910739445006012 0.591073487927515 1.0941633564742759e-06 -0.03974725519991503 -0.27690000000000003 0.5911010032904663 0.5911005263788671 1.0996431133447615e-06 -0.03976004567553177 -0.277 0.5911280576253606 0.5911275602757975 1.1049409021635093e-06 -0.039772834606169837 -0.2771 0.5911551075036157 0.5911545896198989 1.110055811825994e-06 -0.039785621991518964 -0.2772 0.5911821529235551 0.591181614412773 1.1149869602600226e-06 -0.03979840783126916 -0.2773 0.5912091938834947 0.5912086346560301 1.1197334952584015e-06 -0.03981119212511058 -0.27740000000000004 0.5912362303817423 0.5912356503512883 1.1242945938683135e-06 -0.03982397487273359 -0.2775 0.5912632624165992 0.5912626615001746 1.128669462557852e-06 -0.03983675607382889 -0.2776 0.5912902899863591 0.5912896681043226 1.1328573380486873e-06 -0.03984953572808725 -0.2777 0.591317313089309 0.591316670165374 1.1368574868164671e-06 -0.03986231383519973 -0.2778 0.5913443317237299 0.5913436676849781 1.1406692050353051e-06 -0.03987509039485763 -0.27790000000000004 0.591371345887896 0.5913706606647903 1.1442918195214702e-06 -0.03988786540675241 -0.278 0.5913983555800761 0.591397649106473 1.1477246873448088e-06 -0.039900638870575794 -0.2781 0.5914253607985331 0.5914246330116952 1.1509671959952783e-06 -0.03991341078601973 -0.2782 0.5914523615415241 0.5914516123821316 1.1540187635494803e-06 -0.0399261811527763 -0.2783 0.591479357807302 0.5914785872194631 1.1568788386151496e-06 -0.0399389499705379 -0.27840000000000004 0.591506349594114 0.5915055575253758 1.1595469005531989e-06 -0.03995171723899708 -0.2785 0.5915333369002036 0.5915325233015615 1.1620224598107853e-06 -0.03996448295784667 -0.2786 0.5915603197238092 0.5915594845497166 1.1643050578102887e-06 -0.03997724712677968 -0.2787 0.5915872980631655 0.5915864412715426 1.1663942668937999e-06 -0.0399900097454893 -0.2788 0.5916142719165036 0.5916133934687453 1.1682896903786322e-06 -0.04000277081366904 -0.27890000000000004 0.5916412412820511 0.5916403411430347 1.1699909631124328e-06 -0.04001553033101256 -0.279 0.5916682061580323 0.5916672842961243 1.1714977510846047e-06 -0.040028288297213666 -0.2791 0.5916951665426688 0.5916942229297318 1.1728097515928404e-06 -0.04004104471196654 -0.2792 0.5917221224341795 0.591721157045578 1.173926693465166e-06 -0.04005379957496544 -0.2793 0.5917490738307807 0.5917480866453866 1.1748483370599416e-06 -0.04006655288590488 -0.27940000000000004 0.5917760207306874 0.5917750117308841 1.1755744739883056e-06 -0.0400793046444797 -0.2795 0.591802963132112 0.5918019323037996 1.1761049278358193e-06 -0.040092054850384806 -0.2796 0.5918299010332662 0.5918288483658647 1.1764395536073557e-06 -0.04010480350331542 -0.2797 0.5918568344323599 0.5918557599188121 1.176578237949144e-06 -0.040117550602966956 -0.2798 0.5918837633276024 0.5918826669643769 1.176520899259792e-06 -0.04013029614903499 -0.27990000000000004 0.5919106877172023 0.5919095695042951 1.1762674879123303e-06 -0.040143040141215405 -0.28 0.591937607599368 0.5919364675403038 1.175817985588079e-06 -0.040155782579204206 -0.2801 0.5919645229723076 0.591963361074141 1.175172406109315e-06 -0.04016852346269773 -0.2802 0.5919914338342297 0.5919902501075451 1.1743307948841597e-06 -0.040181262791392454 -0.2803 0.5920183401833433 0.5920171346422547 1.1732932289620912e-06 -0.040194000564985045 -0.28040000000000004 0.5920452420178584 0.5920440146800081 1.1720598173670105e-06 -0.040206736783172464 -0.2805 0.5920721393359858 0.592070890222544 1.1706307012637751e-06 -0.040219471445651904 -0.2806 0.5920990321359377 0.5920977612715994 1.1690060531810431e-06 -0.04023220455212065 -0.2807 0.5921259204159285 0.592124627828911 1.1671860775108733e-06 -0.04024493610227635 -0.2808 0.5921528041741738 0.5921514898962137 1.1651710104532143e-06 -0.04025766609581675 -0.28090000000000004 0.5921796834088922 0.592178347475242 1.1629611198493706e-06 -0.04027039453243991 -0.281 0.592206558118304 0.5922052005677272 1.1605567052375143e-06 -0.040283121411844 -0.2811 0.5922334283006331 0.5922320491753994 1.1579580980192183e-06 -0.04029584673372753 -0.2812 0.5922602939541061 0.5922588932999859 1.1551656611819006e-06 -0.04030857049778918 -0.2813 0.5922871550769531 0.5922857329432116 1.1521797891322905e-06 -0.040321292703727765 -0.28140000000000004 0.5923140116674079 0.5923125681067984 1.1490009078074515e-06 -0.040334013351242474 -0.2815 0.5923408637237082 0.5923393987924646 1.1456294749523366e-06 -0.04034673244003256 -0.2816 0.5923677112440959 0.5923662250019253 1.1420659792871213e-06 -0.040359449969797595 -0.2817 0.5923945542268176 0.5923930467368919 1.1383109413953818e-06 -0.040372165940237334 -0.2818 0.5924213926701246 0.5924198639990712 1.1343649128359168e-06 -0.0403848803510517 -0.28190000000000004 0.5924482265722736 0.5924466767901665 1.1302284763092807e-06 -0.04039759320194101 -0.282 0.5924750559315257 0.5924734851118756 1.1259022457688062e-06 -0.04041030449260555 -0.2821 0.592501880746149 0.5925002889658916 1.1213868663095816e-06 -0.040423014222745975 -0.2822 0.5925287010144165 0.5925270883539024 1.1166830139464068e-06 -0.04043572239206317 -0.2823 0.592555516734608 0.5925538832775907 1.1117913956693037e-06 -0.04044842900025816 -0.28240000000000004 0.5925823279050098 0.5925806737386328 1.1067127486663608e-06 -0.04046113404703224 -0.2825 0.5926091345239145 0.5926074597386993 1.1014478416004891e-06 -0.0404738375320869 -0.2826 0.5926359365896223 0.5926342412794547 1.0959974730551103e-06 -0.04048653945512387 -0.2827 0.5926627341004405 0.5926610183625567 1.090362472477846e-06 -0.04049923981584507 -0.2828 0.5926895270546838 0.5926877909896556 1.084543699458873e-06 -0.04051193861395263 -0.28290000000000004 0.5927163154506752 0.5927145591623953 1.0785420438419457e-06 -0.04052463584914894 -0.283 0.5927430992867455 0.5927413228824121 1.0723584253358176e-06 -0.04053733152113661 -0.2831 0.5927698785612343 0.5927680821513337 1.0659937937362862e-06 -0.040550025629618375 -0.2832 0.5927966532724895 0.5927948369707814 1.059449128482104e-06 -0.04056271817429733 -0.2833 0.5928234234188685 0.5928215873423669 1.0527254389602891e-06 -0.04057540915487667 -0.28340000000000004 0.5928501889987372 0.5928483332676937 1.0458237637289702e-06 -0.04058809857105985 -0.2835 0.5928769500104715 0.5928750747483569 1.0387451708504525e-06 -0.04060078642255053 -0.2836 0.5929037064524572 0.592901811785942 1.03149075750264e-06 -0.04061347270905263 -0.2837 0.5929304583230898 0.5929285443820258 1.0240616498957689e-06 -0.040626157430270204 -0.2838 0.5929572056207753 0.592955272538175 1.0164590030503629e-06 -0.04063884058590766 -0.28390000000000004 0.5929839483439303 0.5929819962559469 1.0086840007139664e-06 -0.0406515221756695 -0.284 0.5930106864909821 0.593008715536888 1.0007378551113444e-06 -0.04066420219926046 -0.2841 0.593037420060369 0.5930354303825351 9.9262180658366e-07 -0.04067688065638556 -0.2842 0.5930641490505408 0.5930621407944141 9.843371237827636e-07 -0.04068955754674996 -0.2843 0.5930908734599591 0.59308884677404 9.758851031438365e-07 -0.04070223287005908 -0.28440000000000004 0.5931175932870968 0.5931155483229166 9.672670691907026e-07 -0.04071490662601857 -0.2845 0.5931443085304393 0.5931422454425365 9.58484373453361e-07 -0.040727578814334246 -0.2846 0.5931710191884845 0.5931689381343803 9.495383950508529e-07 -0.04074024943471216 -0.2847 0.5931977252597422 0.5931956263999174 9.40430540274928e-07 -0.04075291848685862 -0.2848 0.5932244267427362 0.5932223102406047 9.311622421181998e-07 -0.04076558597048017 -0.28490000000000004 0.5932511236360023 0.5932489896578862 9.217349603019009e-07 -0.040778251885283445 -0.285 0.59327781593809 0.5932756646531938 9.121501809428167e-07 -0.0407909162309754 -0.2851 0.5933045036475629 0.593302335227947 9.024094164422625e-07 -0.04080357900726324 -0.2852 0.5933311867629978 0.593329001383551 8.92514205125261e-07 -0.0408162402138543 -0.2853 0.5933578652829852 0.5933556631213985 8.824661111017651e-07 -0.0408288998504561 -0.28540000000000004 0.5933845392061311 0.5933823204428688 8.722667239058346e-07 -0.040841557916776565 -0.2855 0.5934112085310552 0.5934089733493265 8.619176582735921e-07 -0.040854214412523626 -0.2856 0.5934378732563919 0.5934356218421231 8.514205541432229e-07 -0.04086686933740556 -0.2857 0.5934645333807909 0.5934622659225951 8.407770759888411e-07 -0.04087952269113081 -0.2858 0.5934911889029171 0.5934889055920651 8.299889129037563e-07 -0.040892174473408066 -0.28590000000000004 0.5935178398214505 0.5935155408518407 8.190577779898511e-07 -0.04090482468394621 -0.286 0.5935444861350868 0.5935421717032144 8.079854085241145e-07 -0.04091747332245434 -0.2861 0.5935711278425382 0.5935687981474639 7.96773565348019e-07 -0.04093012038864177 -0.2862 0.5935977649425321 0.5935954201858511 7.85424032673232e-07 -0.04094276588221808 -0.2863 0.5936243974338131 0.5936220378196226 7.739386178318153e-07 -0.040955409802893 -0.28640000000000004 0.5936510253151417 0.5936486510500094 7.623191512207139e-07 -0.040968052150376556 -0.2865 0.593677648585295 0.5936752598782261 7.50567485413578e-07 -0.040980692924378885 -0.2866 0.5937042672430675 0.5937018643054711 7.386854953550515e-07 -0.040993332124610406 -0.2867 0.5937308812872704 0.5937284643329265 7.266750781109721e-07 -0.04100596975078176 -0.2868 0.5937574907167327 0.5937550599617578 7.145381522022376e-07 -0.041018605802603816 -0.28690000000000004 0.5937840955303006 0.5937816511931138 7.022766576880723e-07 -0.041031240279787606 -0.287 0.5938106957268382 0.5938082380281259 6.898925555276492e-07 -0.04104387318204442 -0.2871 0.5938372913052274 0.5938348204679087 6.773878274968226e-07 -0.04105650450908579 -0.2872 0.5938638822643683 0.593861398513559 6.647644757440396e-07 -0.04106913426062338 -0.2873 0.5938904686031792 0.5938879721661565 6.520245224572729e-07 -0.04108176243636916 -0.28740000000000004 0.5939170503205968 0.5939145414267628 6.391700097529984e-07 -0.04109438903603528 -0.2875 0.5939436274155768 0.5939411062964214 6.262029991765949e-07 -0.04110701405933406 -0.2876 0.5939701998870937 0.593967666776158 6.131255713692774e-07 -0.04111963750597815 -0.2877 0.5939967677341406 0.5939942228669799 5.999398257072741e-07 -0.04113225937568034 -0.2878 0.5940233309557301 0.5940207745698755 5.866478803018271e-07 -0.04114487966815361 -0.28790000000000004 0.5940498895508945 0.5940473218858153 5.732518710555023e-07 -0.04115749838311126 -0.288 0.5940764435186848 0.5940738648157508 5.597539517454564e-07 -0.0411701155202667 -0.2881 0.5941029928581724 0.5941004033606136 5.461562938291475e-07 -0.041182731079333595 -0.2882 0.5941295375684483 0.5941269375213174 5.324610855561573e-07 -0.04119534506002587 -0.2883 0.5941560776486234 0.5941534672987557 5.186705321902352e-07 -0.041207957462057604 -0.28840000000000005 0.5941826130978293 0.594179992693803 5.047868551627532e-07 -0.04122056828514313 -0.2885 0.594209143915217 0.5942065137073141 4.908122919894398e-07 -0.041233177528996995 -0.2886 0.5942356700999587 0.5942330303401241 4.7674909595118997e-07 -0.04124578519333394 -0.2887 0.5942621916512473 0.5942595425930479 4.6259953571936574e-07 -0.041258391277868955 -0.2888 0.5942887085682957 0.5942860504668805 4.483658947035396e-07 -0.041270995782317244 -0.28890000000000005 0.5943152208503386 0.594312553962397 4.3405047102373917e-07 -0.04128359870639419 -0.289 0.5943417284966311 0.5943390530803517 4.196555770802357e-07 -0.041296200049815456 -0.2891 0.5943682315064498 0.5943655478214789 4.051835389984326e-07 -0.04130879981229685 -0.2892 0.5943947298790923 0.5943920381864919 3.906366964900876e-07 -0.04132139799355445 -0.2893 0.5944212236138775 0.5944185241760835 3.7601740225656766e-07 -0.041333994593304536 -0.28940000000000005 0.5944477127101465 0.5944450057909259 3.6132802178068246e-07 -0.04134658961126359 -0.2895 0.5944741971672616 0.5944714830316696 3.465709328964728e-07 -0.04135918304714834 -0.2896 0.594500676984607 0.5944979558989447 3.317485254006325e-07 -0.0413717749006757 -0.2897 0.5945271521615887 0.5945244243933603 3.168632006222971e-07 -0.04138436517156287 -0.2898 0.5945536226976346 0.5945508885155035 3.0191737100671023e-07 -0.04139695385952716 -0.28990000000000005 0.5945800885921949 0.5945773482659403 2.8691345999032336e-07 -0.04140954096428616 -0.29 0.594606549844742 0.5946038036452157 2.718539011403731e-07 -0.04142212648555769 -0.2901 0.5946330064547704 0.5946302546538522 2.567411382659035e-07 -0.04143471042305974 -0.2902 0.594659458421797 0.5946567012923514 2.415776246544876e-07 -0.04144729277651057 -0.2903 0.5946859057453615 0.5946831435611926 2.2636582285018303e-07 -0.041459873545628606 -0.29040000000000005 0.594712348425026 0.5947095814608335 2.1110820423719812e-07 -0.04147245273013253 -0.2905 0.5947387864603748 0.5947360149917098 1.958072485958029e-07 -0.04148503032974121 -0.2906 0.5947652198510158 0.5947624441542355 1.8046544363742312e-07 -0.041497606344173786 -0.2907 0.5947916485965792 0.5947888689488017 1.6508528479647344e-07 -0.04151018077314953 -0.2908 0.5948180726967178 0.5948152893757779 1.4966927468218483e-07 -0.04152275361638801 -0.29090000000000005 0.5948444921511081 0.5948417054355115 1.3421992264145421e-07 -0.041535324873608975 -0.291 0.594870906959449 0.594868117128327 1.1873974445353319e-07 -0.04154789454453239 -0.2911 0.5948973171214627 0.5948945244545273 1.032312618651221e-07 -0.04156046262887846 -0.2912 0.5949237226368943 0.594920927414392 8.769700218791421e-08 -0.04157302912636756 -0.2913 0.5949501235055126 0.5949473260081787 7.213949792042595e-08 -0.041585594036720325 -0.29140000000000005 0.5949765197271092 0.5949737202361226 5.656128623451884e-08 -0.041598157359657585 -0.2915 0.595002911301499 0.595000110098436 4.096490868396585e-08 -0.04161071909490041 -0.2916 0.5950292982285207 0.5950264955953088 2.535291072566781e-08 -0.04162327924217009 -0.2917 0.5950556805080358 0.5950528767269079 9.727841336279464e-09 -0.04163583780118808 -0.2918 0.5950820581399296 0.5950792534933779 -5.90774746830891e-09 -0.0416483947716761 -0.29190000000000005 0.5951084311241104 0.5951056258948402 -2.1551300987722455e-08 -0.041660950153356066 -0.292 0.5951347994605104 0.5951319939313943 -3.7200262266445794e-08 -0.041673503945950124 -0.2921 0.5951611631490851 0.5951583576031156 -5.285207252566076e-08 -0.04168605614918064 -0.2922 0.5951875221898135 0.595184716910058 -6.850417157621899e-08 -0.041698606762770186 -0.2923 0.5952138765826981 0.595211071852252 -8.415399823866188e-08 -0.04171115578644155 -0.29240000000000005 0.5952402263277651 0.595237422429705 -9.979899076237309e-08 -0.04172370321991775 -0.2925 0.5952665714250641 0.5952637686424018 -1.1543658724744166e-07 -0.04173624906292198 -0.2926 0.5952929118746683 0.5952901104903047 -1.3106422605893564e-07 -0.04174879331517774 -0.2927 0.5953192476766743 0.5953164479733526 -1.4667934625234302e-07 -0.04176133597640863 -0.2928 0.5953455788312023 0.5953427810914618 -1.6227938800031372e-07 -0.041773877046338545 -0.29290000000000005 0.5953719053383965 0.5953691098445257 -1.7786179300899319e-07 -0.041786416524691596 -0.293 0.595398227198424 0.595395434232415 -1.934240049135394e-07 -0.041798954411192094 -0.2931 0.5954245444114757 0.5954217542549773 -2.089634697569065e-07 -0.041811490705564544 -0.2932 0.5954508569777662 0.5954480699120378 -2.244776363125034e-07 -0.04182402540753371 -0.2933 0.595477164897533 0.5954743812033984 -2.399639566635914e-07 -0.041836558516824524 -0.29340000000000005 0.5955034681710377 0.5955006881288387 -2.554198864357371e-07 -0.0418490900331622 -0.2935 0.5955297667985652 0.5955269906881153 -2.708428853415157e-07 -0.041861619956272106 -0.2936 0.595556060780423 0.5955532888809625 -2.8623041758296663e-07 -0.041874148285879875 -0.29369999999999996 0.5955823501169435 0.5955795827070914 -3.0157995224711076e-07 -0.04188667502171133 -0.2938 0.5956086348084808 0.5956058721661905 -3.1688896368758934e-07 -0.041899200163492495 -0.29390000000000005 0.5956349148554132 0.5956321572579266 -3.321549319965089e-07 -0.041911723710949665 -0.294 0.5956611902581419 0.595658437981943 -3.4737534347628607e-07 -0.041924245663809284 -0.29410000000000003 0.5956874610170917 0.5956847143378606 -3.625476908963865e-07 -0.04193676602179808 -0.29419999999999996 0.5957137271327099 0.5957109863252784 -3.7766947404149764e-07 -0.041949284784642965 -0.2943 0.5957399886054672 0.5957372539437727 -3.9273820007235116e-07 -0.041961801952071026 -0.29440000000000005 0.5957662454358574 0.5957635171928978 -4.0775138396287325e-07 -0.04197431752380967 -0.2945 0.5957924976243969 0.5957897760721852 -4.227065488471293e-07 -0.041986831499586416 -0.29460000000000003 0.5958187451716251 0.5958160305811449 -4.3760122657443556e-07 -0.04199934387912904 -0.29469999999999996 0.5958449880781046 0.5958422807192643 -4.524329579314035e-07 -0.04201185466216558 -0.2948 0.5958712263444198 0.5958685264860092 -4.67199293224807e-07 -0.04202436384842423 -0.29490000000000005 0.5958974599711786 0.5958947678808232 -4.818977925730161e-07 -0.042036871437633405 -0.295 0.5959236889590107 0.5959210049031283 -4.965260263223303e-07 -0.04204937742952178 -0.29510000000000003 0.5959499133085692 0.5959472375523243 -5.11081575491068e-07 -0.042061881823818204 -0.29519999999999996 0.5959761330205283 0.5959734658277898 -5.255620321997778e-07 -0.04207438462025174 -0.2953 0.5960023480955856 0.5959996897288815 -5.399649999765499e-07 -0.04208688581855171 -0.29540000000000005 0.59602855853446 0.5960259092549351 -5.54288094214983e-07 -0.04209938541844761 -0.2955 0.596054764337893 0.5960521244052647 -5.685289425627627e-07 -0.042111883419669184 -0.29560000000000003 0.5960809655066477 0.5960783351791628 -5.826851853935056e-07 -0.042124379821946376 -0.29569999999999996 0.5961071620415095 0.5961045415759012 -5.967544760565602e-07 -0.04213687462500935 -0.2958 0.596133353943285 0.5961307435947308 -6.107344813766069e-07 -0.042149367828588497 -0.29590000000000005 0.5961595412128028 0.5961569412348812 -6.246228819450916e-07 -0.042161859432414406 -0.296 0.5961857238509125 0.5961831344955612 -6.384173726059483e-07 -0.04217434943621787 -0.29610000000000003 0.5962119018584855 0.5962093233759593 -6.521156628025437e-07 -0.042186837839729936 -0.29619999999999996 0.5962380752364143 0.5962355078752434 -6.657154769662554e-07 -0.04219932464268186 -0.2963 0.5962642439856124 0.5962616879925604 -6.792145550438278e-07 -0.0422118098448051 -0.29640000000000005 0.5962904081070142 0.5962878637270381 -6.926106524696163e-07 -0.04222429344583134 -0.2965 0.596316567601575 0.5963140350777828 -7.05901540998255e-07 -0.04223677544549243 -0.29660000000000003 0.596342722470271 0.5963402020438822 -7.19085008787923e-07 -0.042249255843520565 -0.29669999999999996 0.5963688727140986 0.5963663646244032 -7.32158860844434e-07 -0.042261734639648024 -0.2968 0.5963950183340745 0.5963925228183931 -7.451209194375696e-07 -0.042274211833607356 -0.29690000000000005 0.5964211593312357 0.5964186766248805 -7.579690244896575e-07 -0.042286687425131336 -0.297 0.5964472957066397 0.5964448260428736 -7.707010338808828e-07 -0.04229916141395297 -0.29710000000000003 0.5964734274613634 0.596470971071362 -7.833148237823551e-07 -0.0423116337998054 -0.29719999999999996 0.5964995545965037 0.5964971117093161 -7.95808289044686e-07 -0.04232410458242205 -0.2973 0.5965256771131767 0.5965232479556873 -8.081793436420792e-07 -0.04233657376153658 -0.29740000000000005 0.5965517950125185 0.5965493798094083 -8.204259208388631e-07 -0.04234904133688279 -0.2975 0.596577908295684 0.5965755072693933 -8.325459736613361e-07 -0.042361507308194796 -0.29760000000000003 0.596604016963847 0.5966016303345384 -8.445374753418555e-07 -0.042373971675206845 -0.29769999999999996 0.5966301210182008 0.5966277490037214 -8.56398419374349e-07 -0.04238643443765344 -0.2978 0.5966562204599567 0.5966538632758016 -8.681268201804482e-07 -0.042398895595269284 -0.29790000000000005 0.5966823152903451 0.5966799731496211 -8.797207132205109e-07 -0.04241135514778932 -0.298 0.5967084055106142 0.596706078624004 -8.91178155354444e-07 -0.042423813094948686 -0.29810000000000003 0.5967344911220307 0.5967321796977574 -9.024972253135477e-07 -0.04243626943648274 -0.29819999999999997 0.5967605721258793 0.5967582763696708 -9.136760238392938e-07 -0.042448724172127056 -0.2983 0.5967866485234616 0.5967843686385164 -9.247126741551703e-07 -0.04246117730161741 -0.29840000000000005 0.5968127203160979 0.5968104565030501 -9.356053222164817e-07 -0.04247362882468981 -0.2985 0.5968387875051252 0.5968365399620111 -9.463521369046379e-07 -0.04248607874108056 -0.29860000000000003 0.5968648500918978 0.5968626190141221 -9.569513107765548e-07 -0.04249852705052606 -0.29869999999999997 0.5968909080777867 0.5968886936580892 -9.67401059759343e-07 -0.04251097375276293 -0.2988 0.5969169614641794 0.5969147638926029 -9.776996239552194e-07 -0.04252341884752808 -0.29890000000000005 0.5969430102524805 0.596940829716338 -9.878452676970184e-07 -0.042535862334558604 -0.299 0.5969690544441106 0.5969668911279533 -9.978362796592144e-07 -0.042548304213591785 -0.29910000000000003 0.5969950940405063 0.5969929481260925 -1.0076709738293665e-06 -0.042560744484365164 -0.29919999999999997 0.59702112904312 0.5970190007093842 -1.0173476890640298e-06 -0.04257318314661649 -0.2993 0.5970471594534197 0.5970450488764418 -1.0268647897826444e-06 -0.0425856202000837 -0.29940000000000005 0.5970731852728887 0.5970710926258647 -1.0362206661063134e-06 -0.04259805564450499 -0.2995 0.5970992065030256 0.5970971319562371 -1.0454137341631142e-06 -0.042610489479618735 -0.29960000000000003 0.5971252231453438 0.5971231668661293 -1.0544424363656546e-06 -0.04262292170516355 -0.29969999999999997 0.5971512352013714 0.5971491973540975 -1.0633052416608724e-06 -0.04263535232087824 -0.2998 0.5971772426726508 0.5971752234186847 -1.0720006457520803e-06 -0.04264778132650185 -0.29990000000000006 0.5972032455607388 0.5972012450584194 -1.080527171570811e-06 -0.04266020872177363 -0.3 0.597229243867206 0.5972272622718179 -1.0888833692768163e-06 -0.04267263450643306 -0.30010000000000003 0.5972552375936366 0.5972532750573831 -1.0970678166188907e-06 -0.04268505868021987 -0.30019999999999997 0.5972812267416285 0.5972792834136047 -1.1050791191014042e-06 -0.04269748124287388 -0.3003 0.5973072113127926 0.5973052873389605 -1.1129159104839026e-06 -0.042709902194135244 -0.30040000000000006 0.5973331913087528 0.5973312868319155 -1.120576852697841e-06 -0.042722321533744306 -0.3005 0.5973591667311456 0.5973572818909234 -1.1280606362629175e-06 -0.04273473926144161 -0.30060000000000003 0.59738513758162 0.5973832725144259 -1.1353659803703398e-06 -0.04274715537696793 -0.30069999999999997 0.5974111038618374 0.5974092587008526 -1.1424916333546697e-06 -0.042759569880064255 -0.3008 0.5974370655734705 0.5974352404486226 -1.149436372693824e-06 -0.04277198277047178 -0.30090000000000006 0.5974630227182042 0.5974612177561439 -1.1561990052311177e-06 -0.0427843940479319 -0.301 0.5974889752977346 0.5974871906218138 -1.1627783677303771e-06 -0.04279680371218628 -0.30110000000000003 0.5975149233137687 0.5975131590440188 -1.1691733263763382e-06 -0.04280921176297671 -0.30119999999999997 0.5975408667680246 0.5975391230211359 -1.175382777829359e-06 -0.04282161820004535 -0.3013 0.597566805662231 0.5975650825515315 -1.1814056486703084e-06 -0.04283402302313437 -0.30140000000000006 0.5975927399981267 0.5975910376335631 -1.1872408960666991e-06 -0.04284642623198636 -0.3015 0.5976186697774605 0.5976169882655784 -1.1928875077726886e-06 -0.04285882782634396 -0.30160000000000003 0.5976445950019911 0.5976429344459163 -1.1983445022401007e-06 -0.04287122780595015 -0.30169999999999997 0.5976705156734865 0.5976688761729065 -1.2036109288682262e-06 -0.04288362617054803 -0.3018 0.5976964317937241 0.5976948134448707 -1.2086858686144453e-06 -0.042896022919880976 -0.30190000000000006 0.5977223433644899 0.5977207462601224 -1.2135684335223829e-06 -0.042908418053692596 -0.302 0.5977482503875791 0.5977466746169667 -1.2182577667774197e-06 -0.04292081157172665 -0.30210000000000004 0.5977741528647942 0.5977725985137015 -1.2227530435948708e-06 -0.042933203473727144 -0.30219999999999997 0.5978000507979468 0.5977985179486167 -1.2270534706093628e-06 -0.0429455937594383 -0.3023 0.5978259441888556 0.5978244329199963 -1.2311582868185234e-06 -0.04295798242860459 -0.30240000000000006 0.597851833039347 0.5978503434261163 -1.2350667632499146e-06 -0.04297036948097065 -0.3025 0.5978777173512546 0.5978762494652468 -1.2387782025724547e-06 -0.04298275491628136 -0.30260000000000004 0.5979035971264188 0.5979021510356516 -1.2422919403176635e-06 -0.04299513873428178 -0.30269999999999997 0.5979294723666867 0.5979280481355889 -1.2456073443245508e-06 -0.04300752093471724 -0.3028 0.5979553430739113 0.5979539407633103 -1.248723815017172e-06 -0.04301990151733323 -0.30290000000000006 0.5979812092499521 0.5979798289170632 -1.2516407854046285e-06 -0.04303228048187546 -0.303 0.598007070896674 0.5980057125950897 -1.254357721303112e-06 -0.04304465782808997 -0.30310000000000004 0.5980329280159478 0.598031591795627 -1.2568741213914159e-06 -0.04305703355572288 -0.30319999999999997 0.5980587806096483 0.5980574665169076 -1.2591895176550238e-06 -0.043069407664520554 -0.3033 0.5980846286796564 0.5980833367571603 -1.2613034748865104e-06 -0.04308178015422958 -0.30340000000000006 0.5981104722278567 0.59810920251461 -1.2632155910186071e-06 -0.04309415102459681 -0.3035 0.5981363112561386 0.598135063787478 -1.2649254973462476e-06 -0.04310652027536929 -0.30360000000000004 0.5981621457663945 0.5981609205739826 -1.2664328585265672e-06 -0.043118887906294236 -0.30369999999999997 0.5981879757605212 0.5981867728723385 -1.2677373724123697e-06 -0.0431312539171191 -0.3038 0.5982138012404183 0.5982126206807588 -1.2688387704962167e-06 -0.04314361830759156 -0.30390000000000006 0.5982396222079889 0.5982384639974533 -1.2697368176883828e-06 -0.04315598107745952 -0.304 0.5982654386651383 0.5982643028206304 -1.2704313124833888e-06 -0.04316834222647104 -0.30410000000000004 0.5982912506137745 0.5982901371484967 -1.2709220871265359e-06 -0.043180701754374516 -0.30419999999999997 0.5983170580558074 0.5983159669792573 -1.2712090074473714e-06 -0.04319305966091842 -0.3043 0.5983428609931487 0.5983417923111162 -1.2712919728596894e-06 -0.04320541594585156 -0.30440000000000006 0.5983686594277117 0.598367613142277 -1.2711709167501084e-06 -0.043217770608922915 -0.3045 0.5983944533614105 0.5983934294709421 -1.2708458060339822e-06 -0.04323012364988161 -0.30460000000000004 0.5984202427961605 0.5984192412953142 -1.2703166415994893e-06 -0.043242475068477074 -0.30469999999999997 0.5984460277338775 0.5984450486135963 -1.2695834579745657e-06 -0.043254824864458946 -0.3048 0.598471808176477 0.5984708514239914 -1.2686463235489498e-06 -0.04326717303757702 -0.30490000000000006 0.5984975841258755 0.5984966497247033 -1.267505340518671e-06 -0.04327951958758138 -0.305 0.5985233555839882 0.5985224435139376 -1.2661606448860496e-06 -0.04329186451422229 -0.30510000000000004 0.5985491225527299 0.5985482327899 -1.264612406293164e-06 -0.04330420781725019 -0.30519999999999997 0.5985748850340143 0.5985740175507992 -1.2628608285769616e-06 -0.04331654949641583 -0.3053 0.5986006430297539 0.5985997977948447 -1.2609061487145468e-06 -0.043328889551470046 -0.30540000000000006 0.5986263965418595 0.598625573520249 -1.2587486383219826e-06 -0.04334122798216397 -0.3055 0.5986521455722402 0.5986513447252275 -1.2563886016003778e-06 -0.04335356478824905 -0.30560000000000004 0.5986778901228028 0.5986771114079975 -1.253826377167755e-06 -0.04336589996947674 -0.30569999999999997 0.5987036301954514 0.5987028735667803 -1.2510623371153606e-06 -0.04337823352559883 -0.3058 0.5987293657920874 0.5987286311998006 -1.2480968872297105e-06 -0.043390565456367346 -0.30590000000000006 0.5987550969146088 0.5987543843052865 -1.2449304662709437e-06 -0.043402895761534444 -0.306 0.5987808235649105 0.5987801328814706 -1.24156354724958e-06 -0.04341522444085257 -0.30610000000000004 0.5988065457448833 0.5988058769265903 -1.2379966362052741e-06 -0.04342755149407435 -0.30619999999999997 0.5988322634564142 0.5988316164388872 -1.234230272373349e-06 -0.043439876920952615 -0.3063 0.5988579767013855 0.5988573514166076 -1.230265028573374e-06 -0.043452200721240446 -0.30640000000000006 0.5988836854816753 0.5988830818580042 -1.2261015105430317e-06 -0.043464522894691125 -0.3065 0.5989093897991562 0.5989088077613345 -1.221740357326695e-06 -0.04347684344105814 -0.30660000000000004 0.5989350896556959 0.5989345291248623 -1.2171822406092936e-06 -0.04348916236009519 -0.3067 0.5989607850531564 0.5989602459468577 -1.2124278654379594e-06 -0.043501479651556235 -0.3068 0.5989864759933936 0.5989859582255974 -1.2074779693338478e-06 -0.04351379531519538 -0.30690000000000006 0.5990121624782577 0.5990116659593643 -1.2023333226807154e-06 -0.04352610935076696 -0.307 0.5990378445095919 0.5990373691464497 -1.196994728169809e-06 -0.043538421758025615 -0.30710000000000004 0.5990635220892327 0.5990630677851511 -1.1914630212161992e-06 -0.04355073253672607 -0.30720000000000003 0.5990891952190099 0.5990887618737744 -1.185739069570202e-06 -0.04356304168662334 -0.3073 0.5991148639007458 0.5991144514106338 -1.1798237730953343e-06 -0.043575349207472684 -0.3074 0.5991405281362545 0.599140136394051 -1.1737180638793365e-06 -0.04358765509902948 -0.3075 0.5991661879273428 0.599165816822357 -1.1674229056513052e-06 -0.043599959361049385 -0.30760000000000004 0.5991918432758088 0.5991914926938918 -1.160939294253538e-06 -0.043612261993288264 -0.30770000000000003 0.5992174941834423 0.5992171640070043 -1.154268256864377e-06 -0.04362456299550219 -0.3078 0.5992431406520241 0.5992428307600527 -1.1474108523312765e-06 -0.04363686236744746 -0.3079 0.5992687826833262 0.5992684929514056 -1.1403681706989577e-06 -0.0436491601088806 -0.308 0.5992944202791106 0.5992941505794415 -1.1331413332094087e-06 -0.04366145621955832 -0.30810000000000004 0.59932005344113 0.5993198036425488 -1.1257314919410621e-06 -0.04367375069923751 -0.30820000000000003 0.5993456821711274 0.599345452139127 -1.1181398299198175e-06 -0.0436860435476754 -0.3083 0.5993713064708346 0.5993710960675867 -1.1103675608969965e-06 -0.04369833476462929 -0.3084 0.5993969263419738 0.5993967354263492 -1.1024159285999424e-06 -0.043710624349856814 -0.3085 0.5994225417862561 0.5994223702138476 -1.0942862075091764e-06 -0.04372291230311573 -0.30860000000000004 0.5994481528053812 0.5994480004285265 -1.085979701637152e-06 -0.04373519862416404 -0.30870000000000003 0.5994737594010376 0.5994736260688435 -1.077497745194389e-06 -0.04374748331276002 -0.3088 0.5994993615749022 0.5994992471332672 -1.0688417018123175e-06 -0.04375976636866208 -0.3089 0.59952495932864 0.5995248636202795 -1.0600129646265444e-06 -0.043772047791628875 -0.309 0.5995505526639038 0.5995504755283751 -1.0510129557494974e-06 -0.043784327581419286 -0.30910000000000004 0.5995761415823335 0.599576082856062 -1.0418431263814476e-06 -0.043796605737792385 -0.30920000000000003 0.5996017260855571 0.5996016856018614 -1.0325049565607092e-06 -0.04380888226050751 -0.3093 0.5996273061751888 0.599627283764308 -1.0229999546085278e-06 -0.043821157149324136 -0.3094 0.59965288185283 0.5996528773419505 -1.0133296572678585e-06 -0.043833430404002005 -0.3095 0.5996784531200686 0.5996784663333521 -1.0034956291482544e-06 -0.043845702024301075 -0.30960000000000004 0.5997040199784784 0.5997040507370901 -9.93499462559333e-07 -0.04385797200998148 -0.30970000000000003 0.5997295824296196 0.5997296305517565 -9.833427775385317e-07 -0.04387024036080364 -0.3098 0.5997551404750379 0.5997552057759588 -9.730272212404856e-07 -0.043882507076528104 -0.3099 0.599780694116264 0.5997807764083187 -9.6255446785376e-07 -0.04389477215691567 -0.31 0.5998062433548144 0.5998063424474743 -9.519262182122734e-07 -0.043907035601727366 -0.31010000000000004 0.5998317881921906 0.599831903892079 -9.411441996565184e-07 -0.04391929741072442 -0.31020000000000003 0.5998573286298787 0.5998574607408023 -9.302101655894734e-07 -0.04393155758366834 -0.3103 0.5998828646693491 0.5998830129923296 -9.191258953933357e-07 -0.04394381612032076 -0.3104 0.5999083963120566 0.5999085606453627 -9.078931940964541e-07 -0.043956073020443506 -0.3105 0.5999339235594399 0.5999341036986203 -8.965138918737292e-07 -0.0439683282837987 -0.31060000000000004 0.5999594464129216 0.599959642150838 -8.849898440466131e-07 -0.04398058191014867 -0.31070000000000003 0.5999849648739082 0.5999851760007684 -8.7332293063902e-07 -0.043992833899255915 -0.3108 0.6000104789437886 0.6000107052471816 -8.615150560720153e-07 -0.0440050842508832 -0.3109 0.6000359886239355 0.600036229888865 -8.495681487752371e-07 -0.04401733296479343 -0.311 0.6000614939157044 0.6000617499246239 -8.374841611313855e-07 -0.044029580040749805 -0.31110000000000004 0.6000869948204332 0.6000872653532816 -8.252650690043772e-07 -0.04404182547851568 -0.31120000000000003 0.6001124913394421 0.6001127761736799 -8.129128712952571e-07 -0.044054069277854636 -0.3113 0.6001379834740342 0.6001382823846787 -8.004295898034197e-07 -0.04406631143853053 -0.3114 0.6001634712254942 0.6001637839851569 -7.878172688935425e-07 -0.044078551960307355 -0.3115 0.6001889545950887 0.6001892809740119 -7.75077974912719e-07 -0.044090790842949396 -0.31160000000000004 0.6002144335840656 0.6002147733501603 -7.622137962459696e-07 -0.044103028086221026 -0.31170000000000003 0.6002399081936539 0.600240261112538 -7.492268427611304e-07 -0.044115263689886934 -0.3118 0.6002653784250649 0.6002657442601005 -7.361192454757859e-07 -0.044127497653712044 -0.3119 0.6002908442794901 0.6002912227918229 -7.228931561686913e-07 -0.044139729977461434 -0.312 0.6003163057581017 0.6003166967067 -7.095507470189499e-07 -0.04415196066090037 -0.31210000000000004 0.6003417628620532 0.6003421660037468 -6.960942105227463e-07 -0.044164189703794446 -0.31220000000000003 0.6003672155924777 0.6003676306819983 -6.825257587717015e-07 -0.04417641710590933 -0.3123 0.6003926639504893 0.6003930907405106 -6.68847623314095e-07 -0.044188642867011046 -0.3124 0.6004181079371814 0.6004185461783597 -6.550620546830199e-07 -0.044200866986865726 -0.3125 0.6004435475536277 0.6004439969946422 -6.41171322091072e-07 -0.04421308946523971 -0.31260000000000004 0.6004689828008819 0.6004694431884767 -6.271777130140155e-07 -0.044225310301899655 -0.31270000000000003 0.6004944136799767 0.6004948847590019 -6.130835328299611e-07 -0.04423752949661233 -0.3128 0.6005198401919246 0.6005203217053782 -5.988911045556877e-07 -0.0442497470491448 -0.3129 0.6005452623377169 0.6005457540267873 -5.846027682082644e-07 -0.04426196295926425 -0.313 0.6005706801183239 0.6005711817224327 -5.702208807772946e-07 -0.04427417722673816 -0.31310000000000004 0.6005960935346957 0.6005966047915399 -5.557478154755158e-07 -0.04428638985133421 -0.31320000000000003 0.60062150258776 0.6006220232333556 -5.411859615722658e-07 -0.044298600832820244 -0.3133 0.6006469072784237 0.6006474370471491 -5.26537723949394e-07 -0.044310810170964374 -0.3134 0.6006723076075722 0.600672846232212 -5.118055226571716e-07 -0.04432301786553493 -0.3135 0.6006977035760689 0.6006982507878578 -4.969917925812251e-07 -0.04433522391630042 -0.31360000000000005 0.6007230951847553 0.6007236507134228 -4.820989830123246e-07 -0.04434742832302957 -0.31370000000000003 0.6007484824344513 0.6007490460082661 -4.671295572994394e-07 -0.04435963108549134 -0.3138 0.6007738653259546 0.6007744366717691 -4.520859923362597e-07 -0.04437183220345489 -0.3139 0.6007992438600404 0.6007998227033364 -4.369707782142518e-07 -0.044384031676689605 -0.314 0.6008246180374617 0.6008252041023954 -4.2178641779244685e-07 -0.04439622950496505 -0.31410000000000005 0.6008499878589493 0.6008505808683969 -4.065354263366183e-07 -0.04440842568805109 -0.31420000000000003 0.600875353325211 0.6008759530008148 -3.912203310890705e-07 -0.04442062022571768 -0.3143 0.6009007144369322 0.6009013204991465 -3.7584367076903824e-07 -0.04443281311773509 -0.3144 0.6009260711947751 0.6009266833629126 -3.6040799526737555e-07 -0.04444500436387377 -0.3145 0.6009514235993795 0.6009520415916575 -3.449158651330775e-07 -0.044457193963904365 -0.31460000000000005 0.6009767716513617 0.6009773951849493 -3.293698511847021e-07 -0.04446938191759777 -0.31470000000000004 0.6010021153513152 0.6010027441423795 -3.137725341356701e-07 -0.04448156822472506 -0.3148 0.6010274546998101 0.601028088463564 -2.981265040599701e-07 -0.04449375288505754 -0.3149 0.6010527896973934 0.6010534281481424 -2.8243436005909173e-07 -0.04450593589836674 -0.315 0.6010781203445884 0.6010787631957782 -2.6669870976936405e-07 -0.044518117264424374 -0.31510000000000005 0.6011034466418952 0.6011040936061594 -2.509221689664387e-07 -0.0445302969830024 -0.31520000000000004 0.6011287685897905 0.6011294193789976 -2.3510736112120068e-07 -0.04454247505387296 -0.3153 0.6011540861887268 0.6011547405140295 -2.1925691696261795e-07 -0.044554651476808455 -0.3154 0.6011793994391336 0.6011800570110152 -2.0337347402671346e-07 -0.04456682625158144 -0.3155 0.6012047083414161 0.6012053688697401 -1.874596762471703e-07 -0.04457899937796473 -0.31560000000000005 0.601230012895956 0.6012306760900135 -1.7151817346960918e-07 -0.04459117085573134 -0.31570000000000004 0.6012553131031111 0.6012559786716694 -1.555516210664798e-07 -0.044603340684654484 -0.3158 0.601280608963215 0.6012812766145665 -1.3956267945827716e-07 -0.044615508864507644 -0.3159 0.6013059004765777 0.601306569918588 -1.2355401369026908e-07 -0.04462767539506442 -0.316 0.6013311876434849 0.6013318585836415 -1.0752829296759026e-07 -0.04463984027609869 -0.31610000000000005 0.6013564704641985 0.60135714260966 -9.148819023543919e-08 -0.04465200350738458 -0.31620000000000004 0.6013817489389559 0.6013824219966006 -7.543638169855982e-08 -0.04466416508869634 -0.3163 0.6014070230679707 0.6014076967444458 -5.9375546406642554e-08 -0.0446763250198085 -0.3164 0.6014322928514321 0.6014329668532022 -4.3308365789418435e-08 -0.04468848330049577 -0.3165 0.6014575582895052 0.6014582323229019 -2.7237523220376147e-08 -0.04470063993053308 -0.31660000000000005 0.6014828193823312 0.6014834931536014 -1.1165703558144516e-08 -0.04471279490969559 -0.31670000000000004 0.6015080761300264 0.6015087493453823 4.904407297813551e-09 -0.04472494823775866 -0.3168 0.6015333285326836 0.6015340008983515 2.097012286213229e-08 -0.044737099914497876 -0.3169 0.6015585765903708 0.60155924781264 3.702875650199444e-08 -0.04474924993968902 -0.317 0.6015838203031321 0.601584490088404 5.3077621896616134e-08 -0.04476139831310808 -0.31710000000000005 0.6016090596709869 0.6016097277258249 6.911403347895084e-08 -0.04477354503453129 -0.31720000000000004 0.6016342946939306 0.6016349607251086 8.51353069049321e-08 -0.04478569010373505 -0.3173 0.6016595253719346 0.6016601890864864 1.0113875948541962e-07 -0.044797833520496044 -0.3174 0.6016847517049458 0.6016854128102143 1.1712171063896215e-07 -0.04480997528459112 -0.3175 0.6017099736928868 0.6017106318965726 1.3308148234802974e-07 -0.04482211539579732 -0.31760000000000005 0.6017351913356561 0.6017358463458672 1.4901539958922516e-07 -0.044834253853891955 -0.31770000000000004 0.6017604046331283 0.6017610561584286 1.649207908224759e-07 -0.044846390658652514 -0.3178 0.6017856135851531 0.6017862613346118 1.807949884108373e-07 -0.04485852580985668 -0.3179 0.601810818191557 0.6018114618747971 1.9663532905417336e-07 -0.0448706593072824 -0.318 0.6018360184521417 0.6018366577793891 2.1243915428875715e-07 -0.04488279115070781 -0.31810000000000005 0.6018612143666852 0.6018618490488173 2.2820381090360442e-07 -0.044894921339911256 -0.31820000000000004 0.6018864059349416 0.6018870356835356 2.4392665134292946e-07 -0.044907049874671284 -0.3183 0.6019115931566409 0.6019122176840229 2.596050342612566e-07 -0.04491917675476669 -0.3184 0.6019367760314889 0.6019373950507823 2.7523632489118155e-07 -0.04493130197997645 -0.3185 0.6019619545591682 0.6019625677843415 2.9081789545970516e-07 -0.04494342555007976 -0.31860000000000005 0.6019871287393374 0.6019877358852528 3.0634712575028367e-07 -0.04495554746485604 -0.31870000000000004 0.6020122985716309 0.6020128993540922 3.2182140337344567e-07 -0.04496766772408493 -0.31880000000000003 0.6020374640556603 0.602038058191461 3.3723812434272027e-07 -0.04497978632754625 -0.3189 0.6020626251910127 0.6020632123979839 3.52594693539543e-07 -0.04499190327502005 -0.319 0.6020877819772527 0.60208836197431 3.6788852503244485e-07 -0.045004018566286594 -0.31910000000000005 0.6021129344139207 0.6021135069211125 3.8311704252114165e-07 -0.045016132201126394 -0.31920000000000004 0.602138082500534 0.6021386472390888 3.982776799332788e-07 -0.04502824417932011 -0.31930000000000003 0.6021632262365869 0.6021637829289598 4.133678817297426e-07 -0.04504035450064865 -0.3194 0.6021883656215502 0.6021889139914702 4.283851032932384e-07 -0.04505246316489314 -0.3195 0.6022135006548721 0.6022140404273886 4.433268114417688e-07 -0.045064570171834906 -0.3196 0.6022386313359772 0.6022391622375071 4.581904849143559e-07 -0.04507667552125548 -0.31970000000000004 0.602263757664268 0.6022642794226412 4.7297361462084186e-07 -0.04508877921293663 -0.31980000000000003 0.6022888796391237 0.60228939198363 4.876737042386337e-07 -0.04510088124666032 -0.3199 0.6023139972599014 0.6023144999213358 5.022882705735254e-07 -0.045112981622208746 -0.32 0.602339110525935 0.6023396032366437 5.168148439621545e-07 -0.045125080339364285 -0.3201 0.6023642194365368 0.6023647019304623 5.312509686883349e-07 -0.04513717739790953 -0.32020000000000004 0.6023893239909964 0.602389796003723 5.455942034410244e-07 -0.04514927279762734 -0.32030000000000003 0.6024144241885813 0.6024148854573794 5.59842121744536e-07 -0.045161366538300704 -0.3204 0.6024395200285372 0.6024399702924086 5.73992312333238e-07 -0.04517345861971289 -0.3205 0.6024646115100877 0.6024650505098096 5.880423794568657e-07 -0.045185549041647344 -0.3206 0.6024896986324348 0.602490126110604 6.019899436437992e-07 -0.045197637803887775 -0.32070000000000004 0.6025147813947591 0.6025151970958358 6.158326415484083e-07 -0.04520972490621802 -0.32080000000000003 0.6025398597962193 0.6025402634665706 6.295681269641307e-07 -0.04522181034842218 -0.3209 0.6025649338359533 0.6025653252238959 6.431940707540829e-07 -0.045233894130284565 -0.321 0.6025900035130779 0.6025903823689218 6.567081614894388e-07 -0.04524597625158971 -0.3211 0.6026150688266885 0.6026154349027789 6.70108105810252e-07 -0.04525805671212233 -0.32120000000000004 0.6026401297758601 0.60264048282662 6.833916287585229e-07 -0.04527013551166738 -0.32130000000000003 0.6026651863596468 0.6026655261416187 6.965564741667762e-07 -0.045282212650010006 -0.3214 0.6026902385770826 0.6026905648489702 7.096004051854177e-07 -0.04529428812693559 -0.3215 0.6027152864271808 0.6027155989498904 7.225212043382445e-07 -0.04530636194222969 -0.3216 0.6027403299089349 0.6027406284456155 7.353166743551132e-07 -0.045318434095678144 -0.32170000000000004 0.6027653690213183 0.6027656533374031 7.479846383384725e-07 -0.045330504587066944 -0.32180000000000003 0.6027904037632846 0.6027906736265305 7.605229399298974e-07 -0.04534257341618229 -0.3219 0.602815434133768 0.6028156893142957 7.729294438929557e-07 -0.04535464058281061 -0.322 0.6028404601316836 0.6028407004020163 7.852020366405643e-07 -0.045366706086738574 -0.3221 0.6028654817559265 0.6028657068910299 7.973386262905002e-07 -0.04537876992775304 -0.32220000000000004 0.6028904990053736 0.6028907087826938 8.093371431372454e-07 -0.045390832105641044 -0.32230000000000003 0.6029155118788827 0.6029157060783844 8.211955399850535e-07 -0.04540289262018988 -0.3224 0.6029405203752932 0.6029406987794979 8.329117926197949e-07 -0.04541495147118704 -0.3225 0.602965524493426 0.6029656868874488 8.444839000865123e-07 -0.045427008658420254 -0.3226 0.6029905242320838 0.6029906704036707 8.559098850502433e-07 -0.0454390641816774 -0.32270000000000004 0.6030155195900513 0.6030156493296162 8.671877941290873e-07 -0.04545111804074661 -0.32280000000000003 0.6030405105660956 0.6030406236667556 8.783156980607387e-07 -0.04546317023541627 -0.3229 0.6030654971589664 0.6030655934165776 8.892916922298433e-07 -0.04547522076547486 -0.323 0.6030904793673962 0.603090558580589 9.001138971675982e-07 -0.045487269630711216 -0.3231 0.6031154571901002 0.6031155191603139 9.107804583852186e-07 -0.04549931683091427 -0.32320000000000004 0.6031404306257769 0.6031404751572943 9.212895472343607e-07 -0.04551136236587327 -0.32330000000000003 0.603165399673108 0.603165426573089 9.31639360879366e-07 -0.04552340623537753 -0.3234 0.6031903643307591 0.6031903734092742 9.418281226025726e-07 -0.045535448439216725 -0.3235 0.6032153245973795 0.6032153156674426 9.518540824982047e-07 -0.04554748897718067 -0.3236 0.6032402804716028 0.6032402533492034 9.617155171948166e-07 -0.045559527849059395 -0.32370000000000004 0.6032652319520468 0.6032651864561821 9.714107306602049e-07 -0.04557156505464313 -0.32380000000000003 0.6032901790373142 0.6032901149900203 9.809380540903856e-07 -0.04558360059372235 -0.3239 0.6033151217259921 0.6033150389523753 9.902958466867506e-07 -0.04559563446608772 -0.324 0.6033400600166532 0.6033399583449202 9.99482495572801e-07 -0.045607666671530156 -0.3241 0.6033649939078554 0.6033648731693428 1.008496416099458e-06 -0.04561969720984073 -0.32420000000000004 0.603389923398142 0.6033897834273465 1.017336052205886e-06 -0.04563172608081076 -0.32430000000000003 0.6034148484860424 0.6034146891206488 1.0259998765860256e-06 -0.04564375328423175 -0.3244 0.6034397691700724 0.6034395902509824 1.0344863912714608e-06 -0.045655778819895444 -0.3245 0.6034646854487338 0.6034644868200937 1.0427941274926411e-06 -0.045667802687593774 -0.3246 0.6034895973205151 0.6034893788297433 1.0509216463450155e-06 -0.04567982488711891 -0.32470000000000004 0.6035145047838921 0.6035142662817052 1.0588675385669877e-06 -0.04569184541826319 -0.32480000000000003 0.6035394078373274 0.6035391491777673 1.0666304252338055e-06 -0.0457038642808192 -0.3249 0.6035643064792716 0.6035640275197299 1.0742089575077607e-06 -0.045715881474579736 -0.325 0.6035892007081629 0.6035889013094071 1.0816018176651454e-06 -0.04572789699933784 -0.3251 0.6036140905224272 0.6036137705486245 1.0888077184301181e-06 -0.04573991085488666 -0.32520000000000004 0.6036389759204792 0.603638635239221 1.0958254038073711e-06 -0.04575192304101966 -0.32530000000000003 0.6036638569007221 0.6036634953830469 1.102653649109886e-06 -0.04576393355753047 -0.3254 0.6036887334615479 0.6036883509819642 1.1092912611254668e-06 -0.04577594240421293 -0.3255 0.6037136056013379 0.6037132020378466 1.1157370783387854e-06 -0.045787949580861104 -0.3256 0.6037384733184626 0.6037380485525788 1.121989971569759e-06 -0.04579995508726921 -0.32570000000000005 0.6037633366112829 0.6037628905280565 1.1280488432241498e-06 -0.04581195892323181 -0.32580000000000003 0.6037881954781493 0.603787727966186 1.133912628542566e-06 -0.045823961088543586 -0.3259 0.6038130499174029 0.6038125608688832 1.1395802951286171e-06 -0.045835961582999386 -0.326 0.6038378999273754 0.6038373892380751 1.1450508431432027e-06 -0.04584796040639438 -0.3261 0.6038627455063892 0.6038622130756972 1.1503233061094242e-06 -0.045859957558523845 -0.32620000000000005 0.6038875866527582 0.603887032383695 1.1553967501631845e-06 -0.04587195303918335 -0.32630000000000003 0.6039124233647883 0.603911847164023 1.1602702749413663e-06 -0.045883946848168634 -0.3264 0.6039372556407767 0.6039366574186446 1.1649430136373429e-06 -0.04589593898527567 -0.3265 0.6039620834790127 0.6039614631495309 1.1694141328344454e-06 -0.045907929450300616 -0.3266 0.6039869068777786 0.6039862643586624 1.1736828328112736e-06 -0.04591991824303986 -0.32670000000000005 0.6040117258353496 0.6040110610480263 1.1777483480135409e-06 -0.045931905363290025 -0.32680000000000003 0.604036540349993 0.6040358532196174 1.1816099468875407e-06 -0.045943890810847876 -0.3269 0.6040613504199707 0.6040606408754384 1.1852669317691245e-06 -0.045955874585510405 -0.327 0.6040861560435374 0.6040854240174989 1.1887186393000349e-06 -0.04596785668707491 -0.3271 0.6041109572189426 0.604110202647814 1.1919644409275065e-06 -0.04597983711533875 -0.32720000000000005 0.6041357539444296 0.6041349767684061 1.195003742571199e-06 -0.04599181587009964 -0.32730000000000004 0.6041605462182371 0.6041597463813031 1.1978359844011521e-06 -0.04600379295115541 -0.3274 0.6041853340385981 0.6041845114885387 1.2004606417814756e-06 -0.04601576835830415 -0.3275 0.6042101174037409 0.6042092720921519 1.2028772247707487e-06 -0.04602774209134411 -0.3276 0.60423489631189 0.6042340281941867 1.2050852783995758e-06 -0.046039714150073796 -0.32770000000000005 0.6042596707612655 0.6042587797966914 1.2070843828926314e-06 -0.046051684534291926 -0.32780000000000004 0.6042844407500837 0.6042835269017194 1.2088741532245706e-06 -0.04606365324379737 -0.3279 0.6043092062765578 0.6043082695113272 1.2104542404522967e-06 -0.0460756202783893 -0.328 0.6043339673388977 0.6043330076275757 1.2118243298275821e-06 -0.04608758563786703 -0.3281 0.6043587239353108 0.6043577412525292 1.212984142739959e-06 -0.046099549322030135 -0.32820000000000005 0.6043834760640019 0.6043824703882542 1.2139334358285403e-06 -0.04611151133067837 -0.32830000000000004 0.6044082237231736 0.6044071950368208 1.2146720010375311e-06 -0.046123471663611665 -0.3284 0.6044329669110269 0.6044319152003014 1.2151996659492958e-06 -0.046135430320630194 -0.3285 0.6044577056257612 0.60445663088077 1.21551629389538e-06 -0.04614738730153439 -0.3286 0.6044824398655754 0.6044813420803028 1.215621783234866e-06 -0.04615934260612488 -0.32870000000000005 0.6045071696286666 0.6045060488009775 1.2155160686866395e-06 -0.0461712962342024 -0.32880000000000004 0.6045318949132319 0.6045307510448721 1.2151991203857015e-06 -0.046183248185568015 -0.3289 0.6045566157174684 0.604555448814066 1.2146709439941894e-06 -0.04619519846002293 -0.329 0.6045813320395734 0.6045801421106392 1.2139315808679108e-06 -0.046207147057368614 -0.3291 0.6046060438777446 0.6046048309366716 1.2129811081673658e-06 -0.046219093977406714 -0.32920000000000005 0.6046307512301805 0.6046295152942426 1.2118196386357027e-06 -0.046231039219939075 -0.32930000000000004 0.604655454095081 0.6046541951854313 1.2104473209317845e-06 -0.04624298278476781 -0.3294 0.6046801524706473 0.6046788706123157 1.2088643394081444e-06 -0.046254924671695175 -0.3295 0.6047048463550821 0.604703541576973 1.2070709139999636e-06 -0.04626686488052366 -0.3296 0.6047295357465913 0.6047282080814788 1.2050673002250711e-06 -0.04627880341105599 -0.32970000000000005 0.604754220643382 0.6047528701279062 1.2028537891839441e-06 -0.04629074026309507 -0.32980000000000004 0.6047789010436655 0.6047775277183269 1.2004307075041964e-06 -0.046302675436444035 -0.3299 0.6048035769456548 0.6048021808548096 1.1977984176736456e-06 -0.04631460893090619 -0.33 0.6048282483475673 0.6048268295394204 1.1949573174852013e-06 -0.046326540746285116 -0.3301 0.6048529152476243 0.6048514737742221 1.191907839870332e-06 -0.04633847088238456 -0.33020000000000005 0.6048775776440507 0.604876113561274 1.188650453676221e-06 -0.04635039933900853 -0.33030000000000004 0.6049022355350759 0.6049007489026315 1.185185662777588e-06 -0.04636232611596112 -0.3304 0.6049268889189348 0.604925379800346 1.1815140062432228e-06 -0.04637425121304675 -0.3305 0.6049515377938661 0.6049500062564641 1.177636058447007e-06 -0.04638617463007004 -0.3306 0.6049761821581152 0.6049746282730283 1.1735524289568922e-06 -0.04639809636683576 -0.33070000000000005 0.6050008220099325 0.6049992458520752 1.1692637618687662e-06 -0.046410016423148986 -0.33080000000000004 0.6050254573475751 0.6050238589956365 1.1647707365003424e-06 -0.046421934798814915 -0.3309 0.6050500881693057 0.6050484677057375 1.1600740669748255e-06 -0.04643385149363899 -0.331 0.6050747144733943 0.6050730719843981 1.1551745021376458e-06 -0.04644576650742685 -0.3311 0.6050993362581176 0.6050976718336311 1.1500728252511472e-06 -0.046457679839984306 -0.33120000000000005 0.60512395352176 0.6051222672554433 1.1447698539945872e-06 -0.04646959149111751 -0.33130000000000004 0.6051485662626134 0.6051468582518341 1.1392664406029152e-06 -0.046481501460632714 -0.33140000000000003 0.6051731744789777 0.6051714448247951 1.1335634713671716e-06 -0.04649340974833636 -0.3315 0.605197778169161 0.605196026976311 1.1276618664957105e-06 -0.04650531635403521 -0.3316 0.6052223773314801 0.6052206047083579 1.1215625804750218e-06 -0.04651722127753614 -0.33170000000000005 0.6052469719642608 0.605245178022904 1.1152666011260415e-06 -0.046529124518646256 -0.3318 0.6052715620658382 0.6052697469219086 1.1087749501592636e-06 -0.04654102607717291 -0.33190000000000003 0.605296147634557 0.6052943114073221 1.1020886827306509e-06 -0.046552925952923624 -0.332 0.6053207286687714 0.6053188714810858 1.0952088872195898e-06 -0.046564824145706174 -0.3321 0.6053453051668459 0.6053434271451312 1.0881366849513352e-06 -0.046576720655328474 -0.33220000000000005 0.6053698771271558 0.6053679784013801 1.0808732305023216e-06 -0.046588615481598705 -0.3323 0.605394444548087 0.6053925252517443 1.0734197110895405e-06 -0.04660050862432526 -0.33240000000000003 0.6054190074280362 0.6054170676981245 1.065777346376251e-06 -0.04661240008331669 -0.3325 0.605443565765412 0.6054416057424115 1.0579473884164692e-06 -0.046624289858381816 -0.3326 0.6054681195586344 0.6054661393864842 1.0499311216827234e-06 -0.04663617794932964 -0.33270000000000005 0.6054926688061355 0.605490668632211 1.0417298621778759e-06 -0.046648064355969375 -0.3328 0.6055172135063593 0.6055151934814478 1.0333449580457454e-06 -0.04665994907811041 -0.33290000000000003 0.605541753657763 0.605539713936039 1.0247777888217069e-06 -0.04667183211556243 -0.333 0.6055662892588161 0.6055642299978167 1.0160297653216688e-06 -0.04668371346813524 -0.3331 0.6055908203080016 0.6055887416686002 1.0071023294200288e-06 -0.046695593135638896 -0.33320000000000005 0.6056153468038159 0.6056132489501964 9.979969538831401e-07 -0.046707471117883675 -0.3333 0.6056398687447692 0.6056377518443989 9.887151421472673e-07 -0.04671934741468005 -0.33340000000000003 0.6056643861293854 0.6056622503529879 9.792584279855188e-07 -0.04673122202583868 -0.3335 0.6056888989562033 0.60568674447773 9.69628375258047e-07 -0.0467430949511705 -0.3336 0.6057134072237755 0.6057112342203771 9.598265778010262e-07 -0.04675496619048657 -0.33370000000000005 0.60573791093067 0.605735719582668 9.498546588992962e-07 -0.046766835743598176 -0.3338 0.6057624100754697 0.6057602005663264 9.397142712863626e-07 -0.04677870361031688 -0.33390000000000003 0.605786904656773 0.6057846771730613 9.294070967280632e-07 -0.04679056979045439 -0.334 0.6058113946731939 0.6058091494045668 9.189348457727675e-07 -0.04680243428382265 -0.3341 0.6058358801233625 0.6058336172625209 9.082992575570881e-07 -0.04681429709023377 -0.33420000000000005 0.605860361005925 0.6058580807485874 8.975020993895466e-07 -0.04682615820950018 -0.3343 0.6058848373195438 0.605882539864413 8.865451665562851e-07 -0.046838017641434374 -0.33440000000000003 0.6059093090628985 0.6059069946116288 8.754302820157545e-07 -0.04684987538584914 -0.3345 0.6059337762346853 0.6059314449918496 8.641592960656475e-07 -0.04686173144255745 -0.3346 0.6059582388336178 0.6059558910066736 8.527340859543209e-07 -0.046873585811372534 -0.33470000000000005 0.6059826968584272 0.6059803326576818 8.411565557420175e-07 -0.04688543849210774 -0.3348 0.6060071503078622 0.606004769946438 8.294286360788217e-07 -0.04689728948457669 -0.33490000000000003 0.6060315991806898 0.6060292028744896 8.175522834275029e-07 -0.04690913878859323 -0.335 0.6060560434756949 0.6060536314433653 8.055294802022939e-07 -0.04692098640397138 -0.3351 0.6060804831916808 0.6060780556545764 7.933622342970459e-07 -0.04693283233052534 -0.33520000000000005 0.6061049183274698 0.606102475509616 7.810525785856282e-07 -0.04694467656806956 -0.3353 0.606129348881903 0.6061268910099591 7.686025708664168e-07 -0.04695651911641872 -0.33540000000000003 0.6061537748538407 0.6061513021570619 7.560142933071834e-07 -0.04696835997538767 -0.3355 0.6061781962421624 0.606175708952362 7.432898523063169e-07 -0.04698019914479146 -0.3356 0.6062026130457678 0.6062001113972777 7.304313779654681e-07 -0.0469920366244454 -0.33570000000000005 0.6062270252635757 0.6062245094932086 7.174410236177042e-07 -0.047003872414164954 -0.3358 0.6062514328945253 0.6062489032415342 7.043209657719984e-07 -0.0470157065137658 -0.33590000000000003 0.6062758359375764 0.606273292643615 6.910734036691402e-07 -0.04702753892306392 -0.336 0.6063002343917085 0.6062976777007908 6.777005588098906e-07 -0.04703936964187533 -0.3361 0.6063246282559225 0.6063220584143821 6.64204674649671e-07 -0.04705119867001642 -0.33620000000000005 0.6063490175292396 0.6063464347856891 6.505880162099853e-07 -0.04706302600730366 -0.3363 0.606373402210703 0.6063708068159911 6.368528697175968e-07 -0.047074851653553844 -0.33640000000000003 0.606397782299376 0.6063951745065466 6.230015421604396e-07 -0.0470866756085839 -0.3365 0.6064221577943445 0.6064195378585937 6.090363610933291e-07 -0.047098497872210966 -0.3366 0.6064465286947152 0.6064438968733491 5.9495967402734e-07 -0.04711031844425244 -0.33670000000000005 0.6064708949996174 0.6064682515520083 5.807738480689828e-07 -0.04712213732452585 -0.3368 0.606495256708202 0.6064926018957458 5.664812697259158e-07 -0.047133954512849026 -0.33690000000000003 0.6065196138196421 0.6065169479057138 5.52084344157544e-07 -0.04714577000903993 -0.337 0.6065439663331336 0.6065412895830429 5.375854950223635e-07 -0.04715758381291676 -0.3371 0.6065683142478946 0.6065656269288418 5.229871642004058e-07 -0.04716939592429791 -0.33720000000000006 0.6065926575631659 0.6065899599441971 5.082918110715928e-07 -0.047181206343002 -0.3373 0.6066169962782118 0.6066142886301731 4.935019123353257e-07 -0.04719301506884784 -0.33740000000000003 0.6066413303923189 0.6066386129878116 4.786199613165953e-07 -0.0472048221016545 -0.3375 0.6066656599047979 0.6066629330181317 4.6364846789659353e-07 -0.047216627441241193 -0.3376 0.6066899848149822 0.6066872487221298 4.4858995787433464e-07 -0.04722843108742736 -0.33770000000000006 0.6067143051222286 0.6067115601007794 4.33446972619711e-07 -0.04724023304003265 -0.3378 0.6067386208259187 0.6067358671550309 4.1822206854613686e-07 -0.04725203329887698 -0.33790000000000003 0.6067629319254564 0.6067601698858113 4.0291781684687056e-07 -0.047263831863780345 -0.338 0.6067872384202706 0.6067844682940244 3.875368029260251e-07 -0.04727562873456307 -0.3381 0.6068115403098143 0.6068087623805506 3.720816260099902e-07 -0.04728742391104565 -0.33820000000000006 0.6068358375935642 0.6068330521462465 3.5655489873109847e-07 -0.04729921739304874 -0.3383 0.6068601302710217 0.6068573375919447 3.4095924664190314e-07 -0.04731100918039324 -0.33840000000000003 0.6068844183417126 0.6068816187184545 3.2529730779884414e-07 -0.047322799272900284 -0.3385 0.6069087018051874 0.6069058955265612 3.0957173230428126e-07 -0.0473345876703912 -0.3386 0.6069329806610212 0.6069301680170254 2.937851818346493e-07 -0.0473463743726875 -0.33870000000000006 0.6069572549088139 0.6069544361905836 2.7794032934902457e-07 -0.047358159379610916 -0.3388 0.6069815245481904 0.6069787000479487 2.6203985842299105e-07 -0.04736994269098341 -0.33890000000000003 0.6070057895788007 0.6070029595898085 2.460864628600623e-07 -0.0473817243066271 -0.339 0.6070300500003195 0.6070272148168262 2.3008284627534792e-07 -0.04739350422636433 -0.3391 0.6070543058124475 0.6070514657296409 2.14031721665342e-07 -0.047405282450017724 -0.33920000000000006 0.6070785570149098 0.6070757123288664 1.979358109222007e-07 -0.04741705897741 -0.3393 0.6071028036074577 0.6070999546150925 1.8179784424393608e-07 -0.04742883380836416 -0.33940000000000003 0.6071270455898676 0.6071241925888833 1.6562055991237168e-07 -0.047440606942703384 -0.3395 0.6071512829619415 0.607148426250778 1.4940670366864195e-07 -0.047452378380251056 -0.3396 0.6071755157235068 0.6071726556012916 1.3315902823440862e-07 -0.0474641481208308 -0.33970000000000006 0.6071997438744171 0.6071968806409135 1.1688029291634372e-07 -0.047475916164266434 -0.3398 0.6072239674145512 0.6072211013701077 1.0057326313428483e-07 -0.04748768251038194 -0.33990000000000004 0.6072481863438142 0.6072453177893131 8.424070992857358e-08 -0.04749944715900157 -0.34 0.6072724006621367 0.6072695298989439 6.788540943269972e-08 -0.04751121010994975 -0.3401 0.6072966103694756 0.607293737699388 5.151014255064257e-08 -0.047522971363051114 -0.34020000000000006 0.6073208154658132 0.6073179411910089 3.5117694308084424e-08 -0.04753473091813051 -0.3403 0.6073450159511584 0.6073421403741441 1.871085353842561e-08 -0.047546488775013 -0.34040000000000004 0.6073692118255458 0.6073663352491058 2.292412263488197e-09 -0.04755824493352384 -0.3405 0.6073934030890362 0.6073905258161807 -1.4134834658632855e-08 -0.047569999393488493 -0.3406 0.6074175897417163 0.6074147120756302 -3.056809009388539e-08 -0.04758175215473263 -0.34070000000000006 0.6074417717836995 0.6074388940276901 -4.700455507027773e-08 -0.04759350321708217 -0.3408 0.6074659492151246 0.6074630716725702 -6.344142925948128e-08 -0.04760525258036316 -0.34090000000000004 0.607490122036157 0.6074872450104554 -7.987591146493833e-08 -0.04761700024440191 -0.341 0.6075142902469883 0.6075114140415043 -9.630520009240584e-08 -0.04762874620902492 -0.3411 0.6075384538478363 0.6075355787658506 -1.1272649362917275e-07 -0.04764049047405892 -0.34120000000000006 0.6075626128389445 0.6075597391836023 -1.2913699111438692e-07 -0.04765223303933081 -0.3413 0.6075867672205832 0.6075838952948415 -1.4553389263843863e-07 -0.04766397390466772 -0.34140000000000004 0.6076109169930488 0.6076080470996247 -1.6191439981480538e-07 -0.047675713069896986 -0.3415 0.6076350621566634 0.6076321945979832 -1.782757162345494e-07 -0.04768745053484616 -0.3416 0.6076592027117755 0.6076563377899225 -1.9461504796938756e-07 -0.04769918629934294 -0.34170000000000006 0.6076833386587601 0.6076804766754228 -2.1092960405394434e-07 -0.04771092036321531 -0.3418 0.6077074699980181 0.6077046112544383 -2.2721659694024954e-07 -0.04772265272629145 -0.34190000000000004 0.6077315967299759 0.6077287415268984 -2.43473243032033e-07 -0.04773438338839969 -0.342 0.6077557188550867 0.6077528674927063 -2.596967630455471e-07 -0.047746112349368645 -0.3421 0.6077798363738296 0.6077769891517403 -2.75884382623659e-07 -0.04775783960902706 -0.34220000000000006 0.607803949286709 0.6078011065038533 -2.9203333271748955e-07 -0.047769565167203924 -0.3423 0.6078280575942561 0.6078252195488728 -3.081408500929528e-07 -0.047781289023728434 -0.34240000000000004 0.6078521612970273 0.6078493282866009 -3.2420417783729505e-07 -0.04779301117842999 -0.3425 0.6078762603956054 0.6078734327168147 -3.4022056574073423e-07 -0.04780473163113822 -0.3426 0.6079003548905985 0.6078975328392658 -3.5618727090014346e-07 -0.04781645038168289 -0.34270000000000006 0.6079244447826404 0.6079216286536815 -3.721015580382403e-07 -0.04782816742989407 -0.3428 0.6079485300723908 0.607945720159763 -3.8796070013502604e-07 -0.04783988277560195 -0.34290000000000004 0.6079726107605348 0.6079698073571874 -4.037619787955471e-07 -0.04785159641863699 -0.343 0.6079966868477829 0.6079938902456063 -4.195026847148009e-07 -0.0478633083588298 -0.3431 0.6080207583348711 0.6080179688246473 -4.3518011817733626e-07 -0.04787501859601129 -0.34320000000000006 0.6080448252225606 0.6080420430939122 -4.507915895568537e-07 -0.047886727130012414 -0.3433 0.608068887511638 0.6080661130529791 -4.6633441964927247e-07 -0.04789843396066448 -0.34340000000000004 0.6080929452029147 0.6080901787014013 -4.818059403111086e-07 -0.04791013908779894 -0.3435 0.6081169982972274 0.6081142400387074 -4.972034948064197e-07 -0.04792184251124751 -0.3436 0.6081410467954376 0.6081382970644023 -5.125244382786498e-07 -0.04793354423084201 -0.34370000000000006 0.6081650906984317 0.608162349777966 -5.277661381947185e-07 -0.047945244246414546 -0.3438 0.6081891300071206 0.6081863981788548 -5.429259749278881e-07 -0.047956942557797394 -0.34390000000000004 0.60821316472244 0.608210442266501 -5.580013419659302e-07 -0.047968639164823065 -0.344 0.6082371948453499 0.6082344820403127 -5.729896466327711e-07 -0.047980334067324264 -0.3441 0.6082612203768347 0.6082585174996749 -5.878883103938026e-07 -0.04799202726513388 -0.34420000000000006 0.6082852413179032 0.6082825486439483 -6.026947691889495e-07 -0.04800371875808506 -0.3443 0.6083092576695877 0.6083065754724701 -6.174064741681917e-07 -0.048015408546011065 -0.34440000000000004 0.6083332694329452 0.6083305979845551 -6.320208918303427e-07 -0.04802709662874547 -0.3445 0.6083572766090559 0.6083546161794939 -6.465355048418386e-07 -0.04803878300612199 -0.3446 0.6083812791990242 0.6083786300565543 -6.609478118979606e-07 -0.04805046767797458 -0.34470000000000006 0.6084052772039773 0.6084026396149815 -6.752553287914242e-07 -0.04806215064413735 -0.3448 0.6084292706250665 0.6084266448539977 -6.894555884262576e-07 -0.0480738319044447 -0.34490000000000004 0.6084532594634655 0.6084506457728024 -7.035461412341348e-07 -0.048085511458731134 -0.345 0.6084772437203717 0.6084746423705727 -7.175245559654098e-07 -0.048097189306831406 -0.3451 0.6085012233970052 0.6084986346464637 -7.313884198001386e-07 -0.04810886544858052 -0.34520000000000006 0.6085251984946085 0.6085226225996081 -7.451353387921689e-07 -0.04812053988381364 -0.3453 0.6085491690144472 0.6085466062291166 -7.587629384797623e-07 -0.048132212612366145 -0.34540000000000004 0.6085731349578087 0.6085705855340786 -7.722688639133501e-07 -0.048143883634073605 -0.3455 0.6085970963260029 0.6085945605135612 -7.856507806547341e-07 -0.04815555294877183 -0.3456 0.6086210531203613 0.6086185311666108 -7.989063745827973e-07 -0.04816722055629678 -0.34570000000000006 0.6086450053422379 0.6086424974922522 -8.120333525873935e-07 -0.04817888645648469 -0.3458 0.6086689529930073 0.6086664594894893 -8.250294430967031e-07 -0.04819055064917194 -0.34590000000000004 0.6086928960740665 0.6086904171573053 -8.378923961327445e-07 -0.04820221313419517 -0.346 0.6087168345868331 0.6087143704946625 -8.506199840330186e-07 -0.048213873911391154 -0.3461 0.608740768532746 0.6087383195005028 -8.632100017280653e-07 -0.04822553298059695 -0.34620000000000006 0.6087646979132647 0.6087622641737486 -8.756602668524849e-07 -0.04823719034164979 -0.3463 0.6087886227298692 0.6087862045133009 -8.879686206886284e-07 -0.048248845994387064 -0.34640000000000004 0.6088125429840605 0.6088101405180422 -9.00132927972308e-07 -0.04826049993864645 -0.3465 0.608836458677359 0.608834072186835 -9.121510776421982e-07 -0.04827215217426578 -0.3466 0.6088603698113055 0.6088579995185222 -9.240209831173907e-07 -0.0482838027010831 -0.34670000000000006 0.6088842763874602 0.6088819225119281 -9.357405826304621e-07 -0.048295451518936675 -0.3468 0.6089081784074031 0.6089058411658576 -9.47307839532785e-07 -0.04830709862766497 -0.34690000000000004 0.6089320758727329 0.6089297554790969 -9.587207428773947e-07 -0.04831874402710659 -0.347 0.6089559687850683 0.6089536654504143 -9.69977307474501e-07 -0.04833038771710049 -0.3471 0.6089798571460457 0.6089775710785595 -9.810755743910882e-07 -0.04834202969748566 -0.34720000000000006 0.6090037409573209 0.6090014723622645 -9.920136113117373e-07 -0.048353669968101455 -0.3473 0.6090276202205674 0.6090253693002432 -1.0027895129549602e-06 -0.048365308528787315 -0.34740000000000004 0.6090514949374772 0.6090492618911926 -1.0134014011287107e-06 -0.04837694537938297 -0.3475 0.6090753651097596 0.6090731501337919 -1.0238474253687624e-06 -0.04838858051972827 -0.3476 0.6090992307391419 0.6090970340267037 -1.034125763132998e-06 -0.04840021394966332 -0.34770000000000006 0.6091230918273682 0.6091209135685736 -1.0442346200789654e-06 -0.04841184566902841 -0.3478 0.6091469483762005 0.6091447887580312 -1.054172230507966e-06 -0.048423475677664134 -0.34790000000000004 0.6091708003874164 0.6091686595936898 -1.0639368575593444e-06 -0.04843510397541113 -0.348 0.609194647862811 0.6091925260741463 -1.0735267936545778e-06 -0.04844673056211031 -0.3481 0.6092184908041949 0.6092163881979826 -1.0829403604695198e-06 -0.048458355437602824 -0.34820000000000007 0.6092423292133952 0.609240245963765 -1.0921759096838013e-06 -0.04846997860172999 -0.3483 0.609266163092254 0.6092640993700444 -1.1012318232583862e-06 -0.04848160005433333 -0.34840000000000004 0.6092899924426297 0.6092879484153577 -1.1101065131025045e-06 -0.048493219795254616 -0.3485 0.6093138172663952 0.6093117930982263 -1.118798422072853e-06 -0.04850483782433576 -0.3486 0.6093376375654385 0.6093356334171578 -1.1273060237515509e-06 -0.04851645414141894 -0.34870000000000007 0.6093614533416619 0.6093594693706459 -1.1356278233343176e-06 -0.04852806874634649 -0.3488 0.6093852645969822 0.6093833009571703 -1.1437623570198507e-06 -0.04853968163896094 -0.34890000000000004 0.60940907133333 0.6094071281751977 -1.1517081929535156e-06 -0.048551292819105044 -0.349 0.60943287355265 0.6094309510231815 -1.1594639313938782e-06 -0.04856290228662183 -0.3491 0.6094566712568997 0.6094547694995621 -1.1670282047959724e-06 -0.04857451004135442 -0.34920000000000007 0.60948046444805 0.6094785836027677 -1.1743996780055888e-06 -0.048586116083146225 -0.3493 0.6095042531280846 0.6095023933312143 -1.181577048758875e-06 -0.04859772041184077 -0.34940000000000004 0.6095280372989995 0.6095261986833058 -1.1885590476545804e-06 -0.04860932302728184 -0.3495 0.6095518169628033 0.6095499996574347 -1.195344438459367e-06 -0.04862092392931347 -0.3496 0.6095755921215158 0.6095737962519818 -1.2019320185241433e-06 -0.04863252311777979 -0.34970000000000007 0.6095993627771691 0.6095975884653173 -1.208320618756309e-06 -0.048644120592525236 -0.3498 0.6096231289318063 0.6096213762958009 -1.2145091039250655e-06 -0.04865571635339442 -0.34990000000000004 0.609646890587481 0.6096451597417811 -1.2204963728279505e-06 -0.0486673104002321 -0.35 0.6096706477462581 0.6096689388015974 -1.2262813587904375e-06 -0.04867890273288333 -0.3501 0.6096944004102123 0.609692713473579 -1.2318630291385801e-06 -0.048690493351193256 -0.35020000000000007 0.6097181485814287 0.6097164837560455 -1.2372403863647463e-06 -0.04870208225500735 -0.3503 0.6097418922620017 0.6097402496473077 -1.2424124674059733e-06 -0.048713669444171194 -0.35040000000000004 0.6097656314540353 0.6097640111456678 -1.247378344421124e-06 -0.04872525491853065 -0.3505 0.6097893661596426 0.6097877682494194 -1.2521371247353752e-06 -0.04873683867793174 -0.3506 0.6098130963809447 0.6098115209568478 -1.256687950867974e-06 -0.048748420722220645 -0.35070000000000007 0.6098368221200721 0.6098352692662306 -1.2610300011706155e-06 -0.04876000105124383 -0.3508 0.6098605433791627 0.6098590131758378 -1.265162489411109e-06 -0.04877157966484792 -0.35090000000000005 0.6098842601603623 0.6098827526839328 -1.2690846651342014e-06 -0.04878315656287978 -0.351 0.6099079724658242 0.6099064877887717 -1.2727958140501539e-06 -0.048794731745186476 -0.3511 0.6099316802977084 0.6099302184886042 -1.276295257784943e-06 -0.0488063052116152 -0.35120000000000007 0.6099553836581821 0.609953944781674 -1.279582354324349e-06 -0.04881787696201345 -0.3513 0.6099790825494185 0.6099776666662187 -1.2826564979584454e-06 -0.04882944699622885 -0.35140000000000005 0.6100027769735965 0.6100013841404708 -1.2855171193648651e-06 -0.048841015314109275 -0.3515 0.6100264669329016 0.6100250972026575 -1.28816368605289e-06 -0.04885258191550278 -0.3516 0.6100501524295243 0.6100488058510013 -1.2905957018083392e-06 -0.04886414680025766 -0.35170000000000007 0.6100738334656599 0.61007251008372 -1.292812707553992e-06 -0.04887570996822237 -0.3518 0.6100975100435082 0.6100962098990277 -1.294814280683454e-06 -0.048887271419245565 -0.35190000000000005 0.6101211821652741 0.6101199052951344 -1.2966000359493357e-06 -0.048898831153176135 -0.352 0.6101448498331659 0.6101435962702468 -1.298169624908141e-06 -0.04891038916986317 -0.3521 0.6101685130493956 0.6101672828225686 -1.299522736419867e-06 -0.04892194546915593 -0.35220000000000007 0.6101921718161789 0.6101909649503005 -1.3006590963149378e-06 -0.04893350005090393 -0.3523 0.610215826135734 0.6102146426516408 -1.3015784677272713e-06 -0.048945052914956814 -0.35240000000000005 0.610239476010282 0.6102383159247861 -1.3022806510387674e-06 -0.048956604061164505 -0.3525 0.6102631214420462 0.6102619847679313 -1.3027654839903313e-06 -0.048968153489377136 -0.3526 0.6102867624332519 0.6102856491792696 -1.303032841792895e-06 -0.048979701199444975 -0.35270000000000007 0.6103103989861256 0.6103093091569936 -1.3030826369053727e-06 -0.04899124719121855 -0.3528 0.6103340311028959 0.6103329646992945 -1.302914819478751e-06 -0.04900279146454853 -0.35290000000000005 0.6103576587857913 0.6103566158043641 -1.3025293766899537e-06 -0.04901433401928582 -0.353 0.6103812820370413 0.6103802624703937 -1.3019263336300213e-06 -0.049025874855281565 -0.3531 0.6104049008588757 0.6104039046955752 -1.3011057526934877e-06 -0.04903741397238706 -0.35320000000000007 0.6104285152535238 0.6104275424781008 -1.300067733744914e-06 -0.04904895137045384 -0.3533 0.610452125223215 0.6104511758161645 -1.2988124141188884e-06 -0.049060487049333606 -0.35340000000000005 0.6104757307701769 0.610474804707961 -1.297339968620026e-06 -0.049072021008878274 -0.3535 0.610499331896637 0.6104984291516871 -1.2956506095784803e-06 -0.04908355324893998 -0.3536 0.6105229286048202 0.6105220491455421 -1.2937445866278985e-06 -0.049095083769371065 -0.35370000000000007 0.6105465208969503 0.6105456646877271 -1.291622186982977e-06 -0.049106612570024105 -0.3538 0.6105701087752486 0.6105692757764463 -1.2892837350508835e-06 -0.04911813965075175 -0.35390000000000005 0.6105936922419335 0.6105928824099073 -1.2867295926533018e-06 -0.04912966501140697 -0.354 0.6106172712992207 0.6106164845863206 -1.2839601587211202e-06 -0.049141188651842894 -0.3541 0.6106408459493229 0.6106400823039013 -1.280975869599743e-06 -0.049152710571912894 -0.35420000000000007 0.6106644161944486 0.6106636755608682 -1.277777198882557e-06 -0.04916423077147051 -0.3543 0.610687982036803 0.6106872643554448 -1.274364656966842e-06 -0.04917574925036948 -0.35440000000000005 0.6107115434785861 0.6107108486858595 -1.2707387913313273e-06 -0.04918726600846374 -0.3545 0.6107351005219943 0.610734428550346 -1.266900186452924e-06 -0.049198781045607494 -0.3546 0.6107586531692182 0.6107580039471434 -1.2628494636124366e-06 -0.049210294361655055 -0.35470000000000007 0.6107822014224429 0.6107815748744971 -1.2585872808112963e-06 -0.04922180595646098 -0.3548 0.6108057452838485 0.6108051413306582 -1.2541143325495163e-06 -0.04923331582988005 -0.35490000000000005 0.6108292847556087 0.6108287033138848 -1.2494313502420251e-06 -0.049244823981767216 -0.355 0.6108528198398907 0.6108522608224419 -1.2445391014137552e-06 -0.049256330411977634 -0.3551 0.6108763505388555 0.6108758138546018 -1.2394383899216876e-06 -0.04926783512036669 -0.35520000000000007 0.6108998768546561 0.6108993624086441 -1.234130056010363e-06 -0.049279338106789944 -0.3553 0.6109233987894391 0.6109229064828569 -1.2286149757012588e-06 -0.04929083937110317 -0.35540000000000005 0.6109469163453428 0.6109464460755362 -1.2228940610425898e-06 -0.04930233891316233 -0.3555 0.6109704295244976 0.6109699811849867 -1.216968259776241e-06 -0.04931383673282363 -0.3556 0.6109939383290256 0.6109935118095224 -1.210838555310012e-06 -0.04932533282994342 -0.35570000000000007 0.6110174427610398 0.6110170379474662 -1.2045059664955726e-06 -0.04933682720437828 -0.3558 0.6110409428226444 0.6110405595971506 -1.1979715474064179e-06 -0.04934831985598501 -0.35590000000000005 0.6110644385159344 0.6110640767569182 -1.191236387365624e-06 -0.049359810784620574 -0.356 0.6110879298429949 0.6110875894251222 -1.1843016104740034e-06 -0.04937129999014217 -0.3561 0.6111114168059008 0.6111110976001257 -1.177168375721127e-06 -0.04938278747240721 -0.35620000000000007 0.6111348994067167 0.6111346012803035 -1.1698378764857242e-06 -0.04939427323127323 -0.3563 0.6111583776474968 0.6111581004640407 -1.16231134067446e-06 -0.049405757266598016 -0.35640000000000005 0.6111818515302838 0.611181595149735 -1.1545900303611134e-06 -0.049417239578239604 -0.3565 0.6112053210571098 0.6112050853357958 -1.1466752415922876e-06 -0.049428720166056185 -0.35660000000000003 0.6112287862299943 0.6112285710206438 -1.1385683040543437e-06 -0.04944019902990613 -0.3567000000000001 0.6112522470509455 0.6112520522027132 -1.1302705809346225e-06 -0.04945167616964804 -0.3568 0.6112757035219593 0.6112755288804507 -1.1217834689492001e-06 -0.049463151585140724 -0.35690000000000005 0.6112991556450188 0.6112990010523163 -1.1131083978432876e-06 -0.04947462527624318 -0.357 0.6113226034220942 0.6113224687167832 -1.104246829947142e-06 -0.049486097242814636 -0.35710000000000003 0.6113460468551429 0.6113459318723387 -1.095200260481377e-06 -0.049497567484714476 -0.3572000000000001 0.6113694859461082 0.6113693905174835 -1.0859702169185859e-06 -0.04950903600180229 -0.3573 0.6113929206969198 0.6113928446507337 -1.0765582587335398e-06 -0.04952050279393788 -0.35740000000000005 0.6114163511094935 0.6114162942706194 -1.0669659774309448e-06 -0.0495319678609813 -0.3575 0.6114397771857305 0.6114397393756854 -1.0571949959625737e-06 -0.04954343120279272 -0.35760000000000003 0.6114631989275174 0.6114631799644925 -1.0472469687272667e-06 -0.04955489281923256 -0.3577 0.6114866163367256 0.6114866160356165 -1.0371235809603085e-06 -0.04956635271016144 -0.3578 0.6115100294152117 0.6115100475876494 -1.0268265487056727e-06 -0.04957781087544016 -0.35790000000000005 0.6115334381648161 0.6115334746191994 -1.0163576184551992e-06 -0.04958926731492974 -0.358 0.6115568425873636 0.6115568971288904 -1.005718567120839e-06 -0.04960072202849141 -0.35810000000000003 0.6115802426846628 0.6115803151153638 -9.949112011742312e-07 -0.049612175015986526 -0.3582 0.6116036384585065 0.6116037285772778 -9.839373568409915e-07 -0.04962362627727681 -0.3583 0.6116270299106698 0.6116271375133078 -9.72798899517846e-07 -0.04963507581222402 -0.35840000000000005 0.6116504170429112 0.6116505419221465 -9.614977236338529e-07 -0.049646523620690164 -0.3585 0.6116737998569723 0.6116739418025045 -9.500357521508018e-07 -0.049657969702537476 -0.35860000000000003 0.6116971783545768 0.6116973371531107 -9.384149363966809e-07 -0.04966941405762836 -0.3587 0.611720552537431 0.6117207279727123 -9.26637255649343e-07 -0.04968085668582548 -0.3588 0.6117439224072228 0.6117441142600748 -9.147047168311939e-07 -0.04969229758699163 -0.35890000000000005 0.6117672879656219 0.6117674960139831 -9.026193542871486e-07 -0.04970373676098986 -0.359 0.6117906492142793 0.6117908732332404 -8.903832291740077e-07 -0.049715174207683344 -0.35910000000000003 0.6118140061548275 0.61181424591667 -8.77998429404947e-07 -0.04972660992693554 -0.3592 0.61183735878888 0.6118376140631148 -8.654670690666499e-07 -0.049738043918610114 -0.3593 0.6118607071180306 0.6118609776714368 -8.527912881972632e-07 -0.049749476182570807 -0.35940000000000005 0.6118840511438539 0.611884336740519 -8.399732522867964e-07 -0.04976090671868174 -0.3595 0.6119073908679047 0.6119076912692643 -8.27015152138344e-07 -0.04977233552680709 -0.35960000000000003 0.6119307262917173 0.611931041256596 -8.139192034239962e-07 -0.04978376260681126 -0.3597 0.6119540574168061 0.6119543867014587 -8.00687645963194e-07 -0.049795187958558945 -0.3598 0.6119773842446651 0.6119777276028179 -7.873227438892627e-07 -0.049806611581914906 -0.35990000000000005 0.6120007067767675 0.6120010639596603 -7.738267849000113e-07 -0.04981803347674424 -0.36 0.6120240250145658 0.6120243957709937 -7.602020799524212e-07 -0.049829453642912136 -0.36010000000000003 0.6120473389594905 0.6120477230358481 -7.464509630406013e-07 -0.049840872080284 -0.3602 0.6120706486129517 0.6120710457532754 -7.325757903631214e-07 -0.049852288788725496 -0.3603 0.6120939539763375 0.6120943639223497 -7.185789406005672e-07 -0.04986370376810247 -0.36040000000000005 0.6121172550510142 0.6121176775421674 -7.044628137775621e-07 -0.04987511701828096 -0.3605 0.6121405518383264 0.6121409866118469 -6.902298312627675e-07 -0.049886528539127145 -0.36060000000000003 0.6121638443395959 0.6121642911305302 -6.758824354080595e-07 -0.049897938330507485 -0.3607 0.6121871325561228 0.6121875910973814 -6.614230890211736e-07 -0.04990934639228863 -0.3608 0.6122104164891841 0.6122108865115885 -6.468542747828376e-07 -0.04992075272433738 -0.36090000000000005 0.6122336961400343 0.6122341773723623 -6.321784950802378e-07 -0.049932157326520794 -0.361 0.6122569715099049 0.6122574636789377 -6.173982714241522e-07 -0.049943560198706105 -0.36110000000000003 0.6122802426000039 0.6122807454305725 -6.025161441713944e-07 -0.0499549613407607 -0.3612 0.6123035094115168 0.612304022626549 -5.875346718586805e-07 -0.049966360752552265 -0.3613 0.6123267719456049 0.6123272952661731 -5.724564309667057e-07 -0.04997775843394862 -0.36140000000000005 0.6123500302034062 0.6123505633487754 -5.572840153927894e-07 -0.04998915438481777 -0.3615 0.6123732841860343 0.6123738268737103 -5.420200361039296e-07 -0.050000548605027964 -0.36160000000000003 0.6123965338945798 0.6123970858403573 -5.266671204012807e-07 -0.050011941094447634 -0.3617 0.612419779330108 0.6124203402481205 -5.112279118646423e-07 -0.05002333185294541 -0.3618 0.6124430204936613 0.6124435900964285 -4.957050696863252e-07 -0.05003472088039014 -0.36190000000000005 0.6124662573862564 0.6124668353847349 -4.801012681160399e-07 -0.05004610817665083 -0.362 0.612489490008886 0.6124900761125186 -4.6441919626660777e-07 -0.050057493741596695 -0.36210000000000003 0.6125127183625179 0.6125133122792841 -4.4866155739231584e-07 -0.0500688775750972 -0.3622 0.6125359424480953 0.6125365438845608 -4.328310686391168e-07 -0.05008025967702197 -0.3623 0.6125591622665361 0.6125597709279038 -4.169304603923729e-07 -0.05009164004724081 -0.36240000000000006 0.6125823778187331 0.6125829934088941 -4.0096247599930024e-07 -0.05010301868562376 -0.3625 0.6126055891055542 0.612606211327138 -3.8492987108895704e-07 -0.050114395592041054 -0.36260000000000003 0.6126287961278415 0.6126294246822683 -3.6883541328081026e-07 -0.05012577076636308 -0.3627 0.6126519988864121 0.6126526334739435 -3.5268188157411284e-07 -0.05013714420846052 -0.3628 0.6126751973820571 0.612675837701848 -3.36472065938509e-07 -0.050148515918204184 -0.36290000000000006 0.6126983916155421 0.612699037365693 -3.202087667936171e-07 -0.050159885895465085 -0.363 0.6127215815876069 0.6127222324652155 -3.0389479462739066e-07 -0.05017125414011443 -0.36310000000000003 0.6127447672989653 0.6127454230001792 -2.875329693508011e-07 -0.05018262065202367 -0.3632 0.6127679487503055 0.6127686089703746 -2.711261199439541e-07 -0.05019398543106442 -0.3633 0.6127911259422891 0.6127917903756179 -2.546770838801615e-07 -0.050205348477108495 -0.36340000000000006 0.6128142988755522 0.6128149672157532 -2.3818870671654668e-07 -0.05021670979002794 -0.3635 0.6128374675507039 0.6128381394906502 -2.216638415319938e-07 -0.05022806936969494 -0.36360000000000003 0.6128606319683274 0.6128613072002065 -2.0510534844142558e-07 -0.050239427215981916 -0.3637 0.61288379212898 0.6128844703443457 -1.8851609417253057e-07 -0.050250783328761484 -0.3638 0.6129069480331921 0.6129076289230189 -1.7189895148983503e-07 -0.050262137707906496 -0.36390000000000006 0.6129300996814673 0.6129307829362041 -1.5525679872632758e-07 -0.05027349035328992 -0.364 0.6129532470742833 0.6129539323839064 -1.3859251926304217e-07 -0.05028484126478499 -0.36410000000000003 0.6129763902120908 0.6129770772661579 -1.2190900109537717e-07 -0.05029619044226511 -0.3642 0.6129995290953143 0.6130002175830183 -1.0520913625369777e-07 -0.050307537885603916 -0.3643 0.613022663724351 0.6130233533345739 -8.849582035057313e-08 -0.050318883594675214 -0.36440000000000006 0.6130457940995717 0.6130464845209388 -7.177195205862463e-08 -0.05033022756935297 -0.3645 0.6130689202213206 0.613069611142254 -5.5040432605721334e-08 -0.050341569809511426 -0.36460000000000004 0.6130920420899151 0.6130927331986882 -3.8304165293160525e-08 -0.05035291031502497 -0.3647 0.6131151597056455 0.613115850690437 -2.156605496636023e-08 -0.050364249085768226 -0.3648 0.6131382730687756 0.6131389636177236 -4.829007528052431e-09 -0.05037558612161596 -0.36490000000000006 0.6131613821795423 0.6131620719807986 1.190407058256765e-08 -0.050386921422443234 -0.365 0.6131844870381556 0.6131851757799399 2.863027288337039e-08 -0.05039825498812518 -0.36510000000000004 0.6132075876447991 0.6132082750154527 4.534669336038466e-08 -0.05040958681853722 -0.3652 0.6132306839996287 0.6132313696876697 6.205042697021712e-08 -0.050420916913554964 -0.3653 0.6132537761027743 0.6132544597969509 7.873857013965258e-08 -0.05043224527305419 -0.36540000000000006 0.6132768639543386 0.6132775453436838 9.540822130255089e-08 -0.0504435718969109 -0.3655 0.6132999475543974 0.613300626328283 1.1205648136475288e-07 -0.050454896785001285 -0.36560000000000004 0.6133230269030003 0.6133237027511906 1.2868045422970154e-07 -0.05046621993720173 -0.3657 0.6133461020001696 0.6133467746128757 1.4527724729457292e-07 -0.05047754135338881 -0.3658 0.6133691728459008 0.6133698419138351 1.6184397198804046e-07 -0.05048886103343932 -0.36590000000000006 0.6133922394401631 0.6133929046545926 1.7837774417966967e-07 -0.05050017897723024 -0.366 0.6134153017828992 0.6134159628356992 1.948756848321742e-07 -0.050511495184638766 -0.36610000000000004 0.6134383598740244 0.6134390164577331 2.1133492038305501e-07 -0.05052280965554227 -0.3662 0.6134614137134283 0.6134620655212992 2.2775258326501735e-07 -0.050534122389818296 -0.3663 0.6134844633009736 0.6134851100270302 2.441258124957768e-07 -0.05054543338734466 -0.36640000000000006 0.6135075086364965 0.613508149975585 2.6045175406663734e-07 -0.05055674264799928 -0.3665 0.6135305497198071 0.6135311853676501 2.7672756144209165e-07 -0.050568050171660384 -0.36660000000000004 0.6135535865506891 0.6135542162039384 2.9295039617044383e-07 -0.05057935595820634 -0.3667 0.6135766191288998 0.6135772424851895 3.091174283209597e-07 -0.05059066000751569 -0.3668 0.6135996474541704 0.6136002642121703 3.2522583691407814e-07 -0.0506019623194672 -0.36690000000000006 0.6136226715262061 0.6136232813856737 3.4127281051121727e-07 -0.05061326289393983 -0.367 0.6136456913446859 0.6136462940065194 3.5725554768661905e-07 -0.050624561730812735 -0.36710000000000004 0.6136687069092633 0.6136693020755535 3.7317125746449964e-07 -0.05063585882996529 -0.3672 0.6136917182195658 0.6136923055936485 3.890171598602832e-07 -0.050647154191277015 -0.3673 0.6137147252751949 0.613715304561703 4.0479048631081316e-07 -0.05065844781462769 -0.36740000000000006 0.6137377280757267 0.613738298980642 4.204884802849751e-07 -0.05066973969989724 -0.3675 0.6137607266207121 0.6137612888514163 4.3610839763064124e-07 -0.05068102984696585 -0.36760000000000004 0.6137837209096764 0.6137842741750027 4.516475071297821e-07 -0.050692318255713825 -0.3677 0.6138067109421195 0.6138072549524036 4.671030909564333e-07 -0.05070360492602171 -0.3678 0.6138296967175162 0.6138302311846475 4.824724451069073e-07 -0.05071488985777024 -0.36790000000000006 0.6138526782353166 0.6138532028727881 4.977528800381714e-07 -0.050726173050840366 -0.368 0.6138756554949454 0.6138761700179047 5.129417209592813e-07 -0.05073745450511319 -0.36810000000000004 0.6138986284958029 0.6138991326211019 5.280363084281259e-07 -0.05074873422047008 -0.3682 0.6139215972372647 0.6139220906835091 5.430339987400057e-07 -0.05076001219679253 -0.3683 0.6139445617186823 0.6139450442062813 5.579321643578439e-07 -0.05077128843396226 -0.36840000000000006 0.6139675219393821 0.6139679931905978 5.727281945228091e-07 -0.05078256293186122 -0.3685 0.6139904778986671 0.6139909376376628 5.874194955596268e-07 -0.050793835690371526 -0.36860000000000004 0.6140134295958162 0.6140138775487051 6.020034914733241e-07 -0.05080510670937547 -0.3687 0.6140363770300838 0.6140368129249779 6.164776243655634e-07 -0.0508163759887556 -0.3688 0.6140593202007015 0.6140597437677584 6.30839354726076e-07 -0.05082764352839458 -0.36890000000000006 0.6140822591068769 0.6140826700783478 6.450861620710402e-07 -0.050838909328175336 -0.369 0.6141051937477944 0.6141055918580715 6.592155454010484e-07 -0.05085017338798094 -0.36910000000000004 0.6141281241226151 0.6141285091082782 6.732250235619297e-07 -0.050861435707694726 -0.36920000000000003 0.6141510502304773 0.6141514218303403 6.871121355500609e-07 -0.050872696287200175 -0.3693 0.6141739720704968 0.6141743300256538 7.008744412062562e-07 -0.05088395512638098 -0.36940000000000006 0.6141968896417662 0.614197233695637 7.145095216321007e-07 -0.050895212225121 -0.3695 0.6142198029433563 0.614220132841732 7.280149792454615e-07 -0.050906467583304374 -0.36960000000000004 0.6142427119743152 0.6142430274654032 7.413884388074443e-07 -0.05091772120081533 -0.36970000000000003 0.6142656167336694 0.6142659175681375 7.546275472558595e-07 -0.05092897307753838 -0.3698 0.6142885172204232 0.6142888031514442 7.677299745656452e-07 -0.050940223213358164 -0.3699 0.6143114134335601 0.6143116842168547 7.806934138043786e-07 -0.050951471608159576 -0.37 0.6143343053720416 0.6143345607659221 7.935155819649431e-07 -0.05096271826182767 -0.37010000000000004 0.6143571930348082 0.6143574328002216 8.061942198822614e-07 -0.05097396317424771 -0.37020000000000003 0.6143800764207795 0.6143803003213493 8.187270930659629e-07 -0.05098520634530516 -0.3703 0.6144029555288545 0.6144031633309229 8.311119918669174e-07 -0.050996447774885684 -0.3704 0.6144258303579119 0.6144260218305813 8.433467318103016e-07 -0.051007687462875144 -0.3705 0.6144487009068098 0.614448875821983 8.55429154206222e-07 -0.051018925409159546 -0.37060000000000004 0.6144715671743866 0.6144717253068085 8.673571264550262e-07 -0.05103016161362516 -0.37070000000000003 0.6144944291594606 0.6144945702867576 8.791285421860806e-07 -0.0510413960761584 -0.3708 0.6145172868608314 0.6145174107635505 8.907413221737048e-07 -0.05105262879664595 -0.3709 0.6145401402772785 0.6145402467389269 9.021934141151267e-07 -0.05106385977497459 -0.371 0.6145629894075629 0.6145630782146465 9.134827932133494e-07 -0.051075089011031395 -0.37110000000000004 0.6145858342504267 0.6145859051924876 9.246074628432854e-07 -0.05108631650470352 -0.37120000000000003 0.6146086748045934 0.614608727674248 9.355654546072678e-07 -0.05109754225587845 -0.3713 0.6146315110687686 0.6146315456617443 9.46354828390561e-07 -0.051108766264443765 -0.3714 0.6146543430416399 0.614654359156811 9.569736734438283e-07 -0.05111998853028728 -0.3715 0.6146771707218772 0.6146771681613015 9.67420108216599e-07 -0.051131209053297 -0.37160000000000004 0.6146999941081325 0.6146999726770868 9.776922808291122e-07 -0.05114242783336113 -0.37170000000000003 0.6147228131990414 0.6147227727060554 9.877883692388512e-07 -0.05115364487036807 -0.3718 0.6147456279932224 0.6147455682501134 9.977065819899433e-07 -0.051164860164206405 -0.3719 0.6147684384892772 0.6147683593111841 1.0074451579633603e-06 -0.05117607371476496 -0.372 0.6147912446857915 0.6147911458912072 1.0170023671818296e-06 -0.051187285521932635 -0.37210000000000004 0.6148140465813351 0.6148139279921395 1.0263765110596346e-06 -0.051198495585598705 -0.37220000000000003 0.6148368441744614 0.6148367056159536 1.0355659222360813e-06 -0.05120970390565247 -0.3723 0.6148596374637093 0.6148594787646381 1.0445689655469437e-06 -0.05122091048198355 -0.3724 0.6148824264476019 0.614882247440197 1.0533840377191517e-06 -0.05123211531448166 -0.3725 0.6149052111246481 0.6149050116446505 1.0620095682589703e-06 -0.05124331840303679 -0.37260000000000004 0.6149279914933418 0.614927771380033 1.0704440192299547e-06 -0.05125451974753911 -0.37270000000000003 0.6149507675521627 0.6149505266483939 1.0786858856137727e-06 -0.051265719347878935 -0.3728 0.614973539299577 0.6149732774517969 1.0867336960873608e-06 -0.05127691720394684 -0.3729 0.6149963067340368 0.6149960237923202 1.0945860124400575e-06 -0.05128811331563354 -0.373 0.6150190698539814 0.6150187656720554 1.1022414305172923e-06 -0.05129930768283 -0.37310000000000004 0.6150418286578367 0.615041503093108 1.1096985802760972e-06 -0.05131050030542733 -0.37320000000000003 0.6150645831440165 0.6150642360575961 1.1169561261181737e-06 -0.05132169118331689 -0.3733 0.6150873333109217 0.615086964567651 1.1240127666400923e-06 -0.051332880316390155 -0.3734 0.6151100791569415 0.6151096886254165 1.13086723571576e-06 -0.05134406770453884 -0.3735 0.6151328206804534 0.6151324082330485 1.1375183019413093e-06 -0.05135525334765489 -0.37360000000000004 0.6151555578798233 0.615155123392715 1.1439647693567423e-06 -0.051366437245630364 -0.37370000000000003 0.6151782907534069 0.6151778341065955 1.150205477334909e-06 -0.0513776193983576 -0.3738 0.6152010192995482 0.6152005403768805 1.1562393011921301e-06 -0.05138879980572913 -0.3739 0.6152237435165814 0.6152232422057714 1.1620651521326852e-06 -0.05139997846763755 -0.374 0.6152464634028305 0.6152459395954804 1.167681977276569e-06 -0.05141115538397581 -0.37410000000000004 0.6152691789566098 0.6152686325482295 1.1730887601590911e-06 -0.051422330554636964 -0.37420000000000003 0.6152918901762245 0.615291321066251 1.1782845209251658e-06 -0.05143350397951429 -0.3743 0.6153145970599704 0.6153140051517865 1.183268316468089e-06 -0.05144467565850123 -0.3744 0.6153372996061353 0.6153366848070869 1.1880392402352502e-06 -0.05145584559149152 -0.3745 0.6153599978129976 0.6153593600344116 1.19259642311631e-06 -0.05146701377837895 -0.37460000000000004 0.6153826916788288 0.6153820308360292 1.1969390329436003e-06 -0.05147818021905757 -0.37470000000000003 0.6154053812018923 0.6154046972142155 1.2010662747974354e-06 -0.05148934491342168 -0.3748 0.6154280663804439 0.6154273591712547 1.2049773916722462e-06 -0.0515005078613656 -0.3749 0.6154507472127335 0.6154500167094388 1.2086716638937123e-06 -0.05151166906278411 -0.375 0.6154734236970034 0.6154726698310657 1.2121484096183632e-06 -0.05152282851757194 -0.37510000000000004 0.6154960958314899 0.6154953185384416 1.2154069851388893e-06 -0.051533986225624155 -0.37520000000000003 0.6155187636144238 0.6155179628338777 1.218446784412297e-06 -0.05154514218683592 -0.3753 0.6155414270440305 0.615540602719692 1.2212672401146207e-06 -0.051556296401102736 -0.3754 0.6155640861185293 0.6155632381982078 1.2238678226694777e-06 -0.051567448868320126 -0.3755 0.6155867408361357 0.615585869271754 1.2262480410529797e-06 -0.0515785995883839 -0.37560000000000004 0.6156093911950604 0.6156084959426643 1.2284074427659775e-06 -0.051589748561190064 -0.37570000000000003 0.61563203719351 0.6156311182132771 1.2303456140561053e-06 -0.05160089578663481 -0.3758 0.6156546788296875 0.6156537360859348 1.2320621794459363e-06 -0.05161204126461451 -0.3759 0.6156773161017923 0.615676349562984 1.2335568024823829e-06 -0.05162318499502573 -0.376 0.6156999490080213 0.6156989586467747 1.2348291854591409e-06 -0.05163432697776528 -0.37610000000000005 0.6157225775465679 0.6157215633396597 1.2358790695277122e-06 -0.051645467212730035 -0.37620000000000003 0.615745201715624 0.6157441636439951 1.2367062346974045e-06 -0.051656605699817205 -0.3763 0.6157678215133797 0.6157667595621392 1.2373104999741091e-06 -0.051667742438924136 -0.3764 0.6157904369380228 0.6157893510964523 1.237691723582346e-06 -0.051678877429948346 -0.3765 0.6158130479877406 0.6158119382492963 1.2378498024934181e-06 -0.051690010672787584 -0.37660000000000005 0.6158356546607195 0.6158345210230347 1.2377846728972575e-06 -0.05170114216733978 -0.37670000000000003 0.6158582569551455 0.6158570994200321 1.2374963100914016e-06 -0.0517122719135031 -0.3768 0.6158808548692037 0.6158796734426528 1.2369847287307945e-06 -0.05172339991117578 -0.3769 0.6159034484010806 0.6159022430932624 1.23624998205063e-06 -0.05173452616025634 -0.377 0.6159260375489628 0.6159248083742255 1.2352921630598424e-06 -0.05174565066064351 -0.37710000000000005 0.6159486223110382 0.6159473692879069 1.2341114035696599e-06 -0.051756773412236196 -0.37720000000000004 0.615971202685496 0.6159699258366702 1.2327078745544284e-06 -0.05176789441493349 -0.3773 0.6159937786705268 0.6159924780228774 1.2310817860960999e-06 -0.051779013668634626 -0.3774 0.6160163502643239 0.6160150258488895 1.2292333872732097e-06 -0.0517901311732391 -0.3775 0.6160389174650824 0.6160375693170648 1.2271629664106776e-06 -0.05180124692864653 -0.37760000000000005 0.6160614802710014 0.6160601084297602 1.2248708507467398e-06 -0.05181236093475684 -0.37770000000000004 0.6160840386802819 0.6160826431893294 1.2223574064884613e-06 -0.0518234731914701 -0.3778 0.6161065926911296 0.6161051735981229 1.2196230386452012e-06 -0.05183458369868652 -0.3779 0.6161291423017534 0.6161276996584878 1.216668191139636e-06 -0.051845692456306575 -0.378 0.6161516875103669 0.6161502213727675 1.2134933468632703e-06 -0.05185679946423086 -0.37810000000000005 0.6161742283151879 0.6161727387433014 1.2100990271213252e-06 -0.05186790472236017 -0.37820000000000004 0.61619676471444 0.616195251772424 1.2064857920213168e-06 -0.05187900823059556 -0.3783 0.6162192967063518 0.616217760462465 1.2026542404175444e-06 -0.05189010998883825 -0.3784 0.6162418242891574 0.616240264815749 1.1986050093282241e-06 -0.051901209996989606 -0.3785 0.6162643474610978 0.6162627648345949 1.1943387741575329e-06 -0.05191230825495127 -0.37860000000000005 0.6162868662204196 0.6162852605213156 1.1898562485290753e-06 -0.05192340476262498 -0.37870000000000004 0.6163093805653768 0.6163077518782177 1.1851581842858838e-06 -0.05193449951991275 -0.3788 0.6163318904942305 0.6163302389076011 1.180245371434907e-06 -0.05194559252671676 -0.3789 0.6163543960052494 0.6163527216117586 1.1751186377306766e-06 -0.051956683782939356 -0.379 0.6163768970967102 0.6163751999929756 1.1697788484255067e-06 -0.05196777328848309 -0.37910000000000005 0.6163993937668975 0.61639767405353 1.1642269066580724e-06 -0.05197886104325075 -0.37920000000000004 0.616421886014105 0.6164201437956909 1.1584637531203423e-06 -0.05198994704714524 -0.3793 0.6164443738366348 0.6164426092217195 1.1524903656967567e-06 -0.052001031300069646 -0.3794 0.6164668572327989 0.6164650703338681 1.1463077592699378e-06 -0.052012113801927384 -0.3795 0.616489336200919 0.6164875271343799 1.139916985998246e-06 -0.05202319455262194 -0.37960000000000005 0.6165118107393261 0.6165099796254887 1.1333191345108684e-06 -0.05203427355205706 -0.37970000000000004 0.6165342808463627 0.6165324278094177 1.126515330296396e-06 -0.05204535080013659 -0.3798 0.6165567465203807 0.6165548716883806 1.1195067353697574e-06 -0.05205642629676464 -0.3799 0.6165792077597442 0.6165773112645803 1.1122945477171076e-06 -0.05206750004184551 -0.38 0.6166016645628282 0.6165997465402088 1.1048800014623605e-06 -0.052078572035283655 -0.38010000000000005 0.6166241169280194 0.616622177517447 1.0972643667006565e-06 -0.05208964227698379 -0.38020000000000004 0.6166465648537169 0.616644604198464 1.089448949082028e-06 -0.05210071076685074 -0.3803 0.6166690083383317 0.6166670265854173 1.0814350897558889e-06 -0.05211177750478957 -0.3804 0.6166914473802879 0.6166894446804518 1.0732241647604113e-06 -0.05212284249070551 -0.3805 0.6167138819780227 0.6167118584857004 1.0648175854111042e-06 -0.05213390572450401 -0.38060000000000005 0.6167363121299864 0.6167342680032825 1.0562167974959014e-06 -0.052144967206090714 -0.38070000000000004 0.6167587378346435 0.6167566732353047 1.047423281441695e-06 -0.05215602693537144 -0.3808 0.6167811590904723 0.6167790741838598 1.0384385518702466e-06 -0.05216708491225221 -0.3809 0.6168035758959652 0.6168014708510263 1.0292641573761419e-06 -0.052178141136639156 -0.381 0.61682598824963 0.6168238632388696 1.01990168022148e-06 -0.05218919560843876 -0.38110000000000005 0.6168483961499887 0.61684625134944 1.0103527361138287e-06 -0.05220024832755757 -0.38120000000000004 0.6168707995955792 0.6168686351847729 1.0006189738731575e-06 -0.052211299293902384 -0.38130000000000003 0.6168931985849551 0.6168910147468883 9.907020751820372e-07 -0.05222234850738015 -0.3814 0.6169155931166852 0.6169133900377917 9.806037543913515e-07 -0.05223339596789807 -0.3815 0.6169379831893554 0.6169357610594715 9.703257583260072e-07 -0.05224444167536341 -0.38160000000000005 0.6169603688015679 0.6169581278139014 9.59869865424512e-07 -0.05225548562968381 -0.38170000000000004 0.6169827499519414 0.6169804903030377 9.492378860442852e-07 -0.05226652783076691 -0.38180000000000003 0.6170051266391123 0.6170028485288209 9.384316618787913e-07 -0.05227756827852073 -0.3819 0.6170274988617344 0.6170252024931739 9.274530659020286e-07 -0.05228860697285334 -0.382 0.6170498666184786 0.6170475521980027 9.163040014525947e-07 -0.05229964391367306 -0.3821 0.6170722299080348 0.6170698976451954 9.04986402650021e-07 -0.05231067910088838 -0.38220000000000004 0.6170945887291105 0.6170922388366226 8.93502233534349e-07 -0.05232171253440801 -0.38230000000000003 0.617116943080432 0.6171145757741366 8.818534880938866e-07 -0.052332744214140775 -0.3824 0.6171392929607448 0.6171369084595716 8.700421894602961e-07 -0.05234377413999578 -0.3825 0.6171616383688132 0.6171592368947427 8.580703899363495e-07 -0.052354802311882304 -0.3826 0.6171839793034212 0.6171815610814466 8.459401706628622e-07 -0.05236582872970979 -0.38270000000000004 0.6172063157633723 0.6172038810214602 8.336536408692918e-07 -0.05237685339338789 -0.38280000000000003 0.6172286477474901 0.6172261967165413 8.212129381512945e-07 -0.05238787630282641 -0.3829 0.6172509752546185 0.6172485081684279 8.086202274715237e-07 -0.05239889745793539 -0.383 0.6172732982836215 0.617270815378838 7.958777010486084e-07 -0.052409916858625054 -0.3831 0.6172956168333845 0.6172931183494689 7.829875781906193e-07 -0.052420934504805776 -0.38320000000000004 0.6173179309028136 0.6173154170819982 7.699521045179125e-07 -0.0524319503963882 -0.38330000000000003 0.6173402404908361 0.6173377115780823 7.567735517410856e-07 -0.052442964533283065 -0.3834 0.6173625455964011 0.6173600018393562 7.434542173834213e-07 -0.05245397691540139 -0.3835 0.6173848462184791 0.6173822878674347 7.29996424170265e-07 -0.05246498754265432 -0.3836 0.6174071423560629 0.6174045696639098 7.16402519751469e-07 -0.052475996414953235 -0.38370000000000004 0.6174294340081674 0.6174268472303526 7.026748763683255e-07 -0.052487003532209676 -0.38380000000000003 0.6174517211738298 0.617449120568312 6.888158902984554e-07 -0.05249800889433533 -0.3839 0.6174740038521106 0.6174713896793147 6.748279815782521e-07 -0.052509012501242194 -0.384 0.6174962820420924 0.617493654564865 6.607135933922592e-07 -0.05252001435284235 -0.3841 0.6175185557428815 0.6175159152264444 6.464751919066369e-07 -0.0525310144490481 -0.38420000000000004 0.6175408249536073 0.6175381716655121 6.321152654642503e-07 -0.052542012789771976 -0.38430000000000003 0.6175630896734228 0.6175604238835036 6.176363245846694e-07 -0.05255300937492662 -0.3844 0.6175853499015049 0.6175826718818314 6.030409013257909e-07 -0.052564004204424954 -0.3845 0.6176076056370545 0.6176049156618846 5.883315486454599e-07 -0.052574997278180026 -0.3846 0.6176298568792966 0.6176271552250284 5.735108403043254e-07 -0.05258598859610513 -0.38470000000000004 0.6176521036274802 0.6176493905726044 5.585813702690956e-07 -0.05259697815811363 -0.38480000000000003 0.6176743458808797 0.6176716217059298 5.435457522406928e-07 -0.052607965964119235 -0.3849 0.6176965836387937 0.6176938486262978 5.284066192656756e-07 -0.05261895201403576 -0.385 0.6177188169005455 0.617716071334977 5.131666230839826e-07 -0.05262993630777721 -0.3851 0.6177410456654843 0.6177382898332114 4.978284339068884e-07 -0.05264091884525779 -0.38520000000000004 0.6177632699329838 0.6177605041222204 4.823947399035244e-07 -0.05265189962639192 -0.38530000000000003 0.6177854897024438 0.6177827142031982 4.668682466596463e-07 -0.052662878651094175 -0.3854 0.6178077049732891 0.6178049200773138 4.51251676664155e-07 -0.05267385591927929 -0.3855 0.6178299157449707 0.617827121745711 4.355477689482745e-07 -0.05268483143086225 -0.3856 0.6178521220169654 0.6178493192095086 4.197592786137072e-07 -0.0526958051857582 -0.38570000000000004 0.6178743237887765 0.6178715124697992 4.038889761387443e-07 -0.05270677718388253 -0.38580000000000003 0.617896521059933 0.6178937015276501 3.879396471700991e-07 -0.05271774742515074 -0.3859 0.6179187138299903 0.6179158863841022 3.719140919122843e-07 -0.052728715909478543 -0.386 0.6179409020985306 0.6179380670401707 3.5581512455862274e-07 -0.05273968263678186 -0.3861 0.6179630858651626 0.6179602434968449 3.3964557293042485e-07 -0.05275064760697678 -0.38620000000000004 0.6179852651295222 0.6179824157550871 3.2340827800514393e-07 -0.05276161081997961 -0.38630000000000003 0.6180074398912717 0.6180045838158337 3.071060932224867e-07 -0.05277257227570684 -0.3864 0.6180296101501005 0.6180267476799947 2.907418841374687e-07 -0.05278353197407511 -0.3865 0.6180517759057252 0.6180489073484527 2.7431852786530264e-07 -0.05279448991500127 -0.3866 0.6180739371578898 0.6180710628220643 2.5783891269975934e-07 -0.05280544609840235 -0.38670000000000004 0.6180960939063657 0.6180932141016587 2.413059373984616e-07 -0.05281640052419562 -0.38680000000000003 0.6181182461509515 0.6181153611880387 2.2472251082900074e-07 -0.05282735319229849 -0.3869 0.6181403938914738 0.6181375040819794 2.0809155138606927e-07 -0.052838304102628575 -0.387 0.6181625371277863 0.6181596427842291 1.9141598648492186e-07 -0.05284925325510367 -0.3871 0.6181846758597711 0.6181817772955088 1.7469875209646935e-07 -0.05286020064964177 -0.38720000000000004 0.6182068100873375 0.6182039076165121 1.5794279217828944e-07 -0.05287114628616103 -0.38730000000000003 0.6182289398104228 0.6182260337479053 1.411510581403319e-07 -0.052882090164579856 -0.3874 0.6182510650289927 0.6182481556903271 1.2432650840082937e-07 -0.05289303228481677 -0.3875 0.6182731857430406 0.6182702734443888 1.0747210779996075e-07 -0.05290397264679051 -0.3876 0.6182953019525881 0.6182923870106737 9.059082712106759e-08 -0.05291491125042002 -0.38770000000000004 0.618317413657685 0.6183144963897378 7.368564251472587e-08 -0.05292584809562441 -0.38780000000000003 0.6183395208584093 0.6183366015821091 5.6759535023431784e-08 -0.05293678318232298 -0.3879 0.6183616235548667 0.6183587025882887 3.98154900334291e-08 -0.052947716510435255 -0.388 0.6183837217471922 0.6183807994087487 2.2856496756026856e-08 -0.05295864807988089 -0.3881 0.6184058154355487 0.6184028920439337 5.8855476881003455e-09 -0.05296957789057976 -0.38820000000000005 0.6184279046201273 0.6184249804942608 -1.1094361908325912e-08 -0.05298050594245194 -0.38830000000000003 0.6184499893011478 0.6184470647601188 -2.8080234529964665e-08 -0.05299143223541765 -0.3884 0.6184720694788581 0.6184691448418687 -4.50690709726323e-08 -0.05300235676939735 -0.3885 0.6184941451535347 0.6184912207398436 -6.205787085535215e-08 -0.053013279544311655 -0.3886 0.6185162163254827 0.6185132924543486 -7.904363315356516e-08 -0.053024200560081364 -0.38870000000000005 0.6185382829950358 0.6185353599856607 -9.602335672345003e-08 -0.0530351198166275 -0.38880000000000003 0.6185603451625554 0.6185574233340291 -1.1299404084445797e-07 -0.05304603731387121 -0.3889 0.6185824028284324 0.6185794824996748 -1.2995268573907925e-07 -0.053056953051733906 -0.389 0.6186044559930854 0.618601537482791 -1.4689629311559482e-07 -0.053067867030137154 -0.3891 0.6186265046569617 0.6186235882835429 -1.6382186668328913e-07 -0.05307877924900265 -0.38920000000000005 0.6186485488205369 0.6186456349020678 -1.8072641269975542e-07 -0.05308968970825239 -0.38930000000000003 0.6186705884843158 0.6186676773384749 -1.9760694048784333e-07 -0.053100598407808466 -0.3894 0.6186926236488302 0.6186897155928459 -2.14460462999444e-07 -0.05311150534759323 -0.3895 0.6187146543146416 0.6187117496652343 -2.3128399728733484e-07 -0.05312241052752917 -0.3896 0.6187366804823388 0.618733779555666 -2.4807456507069947e-07 -0.05313331394753898 -0.38970000000000005 0.6187587021525393 0.6187558052641385 -2.6482919327636134e-07 -0.05314421560754552 -0.38980000000000004 0.6187807193258889 0.6187778267906223 -2.815449145210369e-07 -0.05315511550747183 -0.3899 0.6188027320030614 0.61879984413506 -2.982187677219583e-07 -0.05316601364724119 -0.39 0.6188247401847586 0.6188218572973662 -3.148477984993292e-07 -0.05317691002677702 -0.3901 0.618846743871711 0.6188438662774283 -3.3142905981470294e-07 -0.05318780464600296 -0.39020000000000005 0.6188687430646765 0.6188658710751064 -3.479596124358886e-07 -0.05319869750484282 -0.39030000000000004 0.6188907377644408 0.6188878716902327 -3.644365254712456e-07 -0.053209588603220594 -0.3904 0.618912727971818 0.6189098681226124 -3.8085687692479553e-07 -0.05322047794106047 -0.3905 0.6189347136876493 0.6189318603720231 -3.9721775411949434e-07 -0.053231365518286805 -0.3906 0.6189566949128043 0.6189538484382153 -4.1351625437724415e-07 -0.05324225133482419 -0.39070000000000005 0.6189786716481797 0.6189758323209129 -4.297494853727768e-07 -0.05325313539059735 -0.39080000000000004 0.6190006438946994 0.6189978120198123 -4.4591456574427646e-07 -0.05326401768553124 -0.3909 0.6190226116533155 0.6190197875345829 -4.6200862559298006e-07 -0.05327489821955096 -0.391 0.6190445749250066 0.6190417588648672 -4.78028806955022e-07 -0.053285776992581795 -0.3911 0.6190665337107792 0.6190637260102818 -4.939722643287903e-07 -0.05329665400454928 -0.39120000000000005 0.6190884880116663 0.6190856889704162 -5.098361652577932e-07 -0.0533075292553791 -0.39130000000000004 0.6191104378287277 0.6191076477448332 -5.2561769070536e-07 -0.053318402744997065 -0.3914 0.6191323831630505 0.61912960233307 -5.413140357207746e-07 -0.05332927447332928 -0.3915 0.6191543240157487 0.6191515527346368 -5.569224097029535e-07 -0.05334014444030199 -0.3916 0.6191762603879616 0.6191734989490183 -5.724400371637239e-07 -0.05335101264584157 -0.39170000000000005 0.619198192280856 0.619195440975673 -5.878641580470134e-07 -0.053361879089874636 -0.39180000000000004 0.619220119695625 0.619217378814034 -6.031920282700831e-07 -0.05337274377232805 -0.3919 0.6192420426334871 0.6192393124635084 -6.184209202647617e-07 -0.05338360669312878 -0.392 0.6192639610956873 0.6192612419234778 -6.335481233382678e-07 -0.05339446785220395 -0.3921 0.6192858750834962 0.6192831671932989 -6.485709443809773e-07 -0.053405327249480966 -0.39220000000000005 0.61930778459821 0.6193050882723028 -6.634867080745899e-07 -0.05341618488488734 -0.39230000000000004 0.6193296896411503 0.6193270051597957 -6.782927576137743e-07 -0.05342704075835082 -0.3924 0.6193515902136644 0.6193489178550593 -6.929864551363796e-07 -0.05343789486979936 -0.3925 0.6193734863171241 0.6193708263573503 -7.075651819177242e-07 -0.053448747219160965 -0.3926 0.6193953779529265 0.6193927306659011 -7.220263391893855e-07 -0.053459597806363994 -0.39270000000000005 0.6194172651224937 0.6194146307799198 -7.363673485139e-07 -0.053470446631336904 -0.39280000000000004 0.6194391478272717 0.6194365266985904 -7.50585652187219e-07 -0.05348129369400835 -0.3929 0.6194610260687314 0.6194584184210732 -7.646787137105537e-07 -0.05349213899430719 -0.393 0.6194828998483679 0.6194803059465044 -7.786440182344645e-07 -0.05350298253216245 -0.3931 0.6195047691676999 0.6195021892739971 -7.924790730862163e-07 -0.05351382430750338 -0.39320000000000005 0.61952663402827 0.6195240684026411 -8.061814080750906e-07 -0.05352466432025931 -0.39330000000000004 0.6195484944316444 0.619545943331503 -8.197485762417855e-07 -0.05353550257035988 -0.3934 0.619570350379413 0.6195678140596264 -8.33178153858416e-07 -0.0535463390577349 -0.3935 0.6195922018731878 0.6195896805860325 -8.464677412334254e-07 -0.053557173782314255 -0.3936 0.6196140489146047 0.61961154290972 -8.596149629891414e-07 -0.05356800674402812 -0.39370000000000005 0.6196358915053216 0.6196334010296654 -8.726174685058652e-07 -0.05357883794280682 -0.39380000000000004 0.6196577296470195 0.6196552549448232 -8.854729322826937e-07 -0.053589667378580896 -0.39390000000000003 0.619679563341401 0.6196771046541264 -8.981790544371204e-07 -0.05360049505128102 -0.394 0.6197013925901909 0.6196989501564865 -9.107335611213685e-07 -0.05361132096083807 -0.3941 0.6197232173951356 0.6197207914507934 -9.231342050219915e-07 -0.05362214510718319 -0.39420000000000005 0.619745037758003 0.6197426285359163 -9.353787655819179e-07 -0.053632967490247554 -0.3943 0.6197668536805824 0.6197644614107038 -9.474650493890291e-07 -0.053643788109962634 -0.39440000000000003 0.6197886651646837 0.6197862900739834 -9.593908908422932e-07 -0.053654606966260024 -0.3945 0.6198104722121378 0.6198081145245634 -9.71154152235032e-07 -0.0536654240590716 -0.3946 0.6198322748247961 0.6198299347612312 -9.827527244210543e-07 -0.05367623938832933 -0.39470000000000005 0.6198540730045298 0.619851750782755 -9.941845268979232e-07 -0.05368705295396542 -0.3948 0.61987586675323 0.6198735625878835 -1.005447508445334e-06 -0.053697864755912185 -0.39490000000000003 0.619897656072808 0.6198953701753462 -1.01653964740267e-06 -0.05370867479410222 -0.395 0.6199194409651938 0.6199171735438537 -1.0274589518077804e-06 -0.05371948306846824 -0.3951 0.6199412214323369 0.6199389726920976 -1.038203460396181e-06 -0.05373028957894317 -0.39520000000000005 0.6199629974762051 0.6199607676187525 -1.0487712422124762e-06 -0.05374109432546015 -0.3953 0.6199847690987853 0.6199825583224735 -1.0591603973597596e-06 -0.053751897307952407 -0.39540000000000003 0.620006536302082 0.6200043448018988 -1.0693690574159476e-06 -0.05376269852635346 -0.3955 0.6200282990881181 0.6200261270556492 -1.0793953853782678e-06 -0.053773497980596954 -0.3956 0.6200500574589338 0.6200479050823279 -1.0892375764681717e-06 -0.05378429567061676 -0.39570000000000005 0.6200718114165868 0.6200696788805213 -1.0988938580758223e-06 -0.05379509159634688 -0.3958 0.6200935609631517 0.6200914484487998 -1.1083624905094958e-06 -0.05380588575772154 -0.39590000000000003 0.6201153061007197 0.6201132137857173 -1.1176417668845584e-06 -0.05381667815467514 -0.396 0.6201370468313985 0.6201349748898113 -1.126730013650823e-06 -0.05382746878714222 -0.3961 0.6201587831573119 0.6201567317596046 -1.135625590814593e-06 -0.053838257655057634 -0.39620000000000005 0.6201805150805995 0.6201784843936039 -1.144326892327241e-06 -0.05384904475835624 -0.3963 0.6202022426034162 0.6202002327903015 -1.15283234639052e-06 -0.05385983009697323 -0.39640000000000003 0.6202239657279318 0.6202219769481747 -1.1611404155953409e-06 -0.05387061367084389 -0.3965 0.6202456844563315 0.6202437168656867 -1.1692495974768846e-06 -0.053881395479903754 -0.3966 0.6202673987908145 0.6202654525412865 -1.1771584244035793e-06 -0.05389217552408848 -0.39670000000000005 0.6202891087335943 0.6202871839734099 -1.18486546427099e-06 -0.053902953803333965 -0.3968 0.6203108142868983 0.6203089111604787 -1.1923693203075292e-06 -0.05391373031757627 -0.39690000000000003 0.6203325154529671 0.6203306341009023 -1.1996686318516137e-06 -0.05392450506675161 -0.397 0.6203542122340543 0.6203523527930768 -1.206762074212886e-06 -0.05393527805079641 -0.3971 0.6203759046324268 0.6203740672353866 -1.2136483590607927e-06 -0.053946049269647245 -0.39720000000000005 0.6203975926503635 0.6203957774262037 -1.2203262346188737e-06 -0.05395681872324096 -0.3973 0.6204192762901559 0.6204174833638887 -1.2267944858590507e-06 -0.05396758641151448 -0.39740000000000003 0.6204409555541068 0.6204391850467909 -1.233051934945717e-06 -0.05397835233440499 -0.3975 0.6204626304445306 0.6204608824732487 -1.2390974411802258e-06 -0.05398911649184987 -0.3976 0.6204843009637526 0.6204825756415897 -1.2449299014727355e-06 -0.05399987888378656 -0.39770000000000005 0.6205059671141091 0.6205042645501311 -1.2505482503144538e-06 -0.054010639510152794 -0.3978 0.6205276288979462 0.6205259491971812 -1.2559514601107047e-06 -0.054021398370886486 -0.39790000000000003 0.6205492863176207 0.6205476295810376 -1.261138541208684e-06 -0.054032155465925706 -0.398 0.6205709393754986 0.6205693056999892 -1.2661085425358376e-06 -0.054042910795208704 -0.3981 0.6205925880739553 0.6205909775523165 -1.2708605511280169e-06 -0.05405366435867396 -0.39820000000000005 0.620614232415375 0.620612645136291 -1.2753936927123455e-06 -0.05406441615626004 -0.3983 0.6206358724021501 0.6206343084501762 -1.2797071319015085e-06 -0.054075166187905754 -0.39840000000000003 0.6206575080366823 0.6206559674922278 -1.2838000722215082e-06 -0.05408591445355011 -0.3985 0.62067913932138 0.6206776222606949 -1.287671756278197e-06 -0.05409666095313231 -0.3986 0.6207007662586594 0.6206992727538185 -1.2913214659238115e-06 -0.05410740568659165 -0.39870000000000005 0.6207223888509442 0.620720918969834 -1.2947485221737054e-06 -0.05411814865386773 -0.3988 0.620744007100664 0.6207425609069696 -1.2979522859279946e-06 -0.05412888985490021 -0.39890000000000003 0.6207656210102553 0.6207641985634484 -1.3009321574442012e-06 -0.054139629289629024 -0.399 0.6207872305821603 0.6207858319374878 -1.3036875768368539e-06 -0.054150366957994245 -0.3991 0.6208088358188273 0.6208074610273003 -1.3062180240219767e-06 -0.05416110285993623 -0.39920000000000005 0.6208304367227088 0.6208290858310931 -1.308523018994645e-06 -0.05417183699539531 -0.3993 0.620852033296263 0.6208507063470694 -1.3106021216902075e-06 -0.05418256936431222 -0.39940000000000003 0.6208736255419521 0.6208723225734285 -1.3124549320953083e-06 -0.054193299966627674 -0.3995 0.6208952134622427 0.6208939345083657 -1.3140810907474876e-06 -0.054204028802282755 -0.3996 0.620916797059605 0.6209155421500735 -1.315480278318848e-06 -0.0542147558712186 -0.39970000000000006 0.6209383763365119 0.6209371454967414 -1.3166522157548322e-06 -0.05422548117337658 -0.3998 0.6209599512954403 0.6209587445465563 -1.3175966645240234e-06 -0.05423620470869828 -0.39990000000000003 0.620981521938869 0.6209803392977034 -1.3183134266459007e-06 -0.05424692647712544 -0.4 0.6210030882692792 0.6210019297483658 -1.3188023446075725e-06 -0.05425764647859993 -0.4001 0.6210246502891532 0.6210235158967256 -1.3190633014470432e-06 -0.05426836471306386 -0.40020000000000006 0.6210462080009758 0.6210450977409632 -1.3190962209197465e-06 -0.05427908118045949 -0.4003 0.6210677614072315 0.6210666752792595 -1.3189010673597679e-06 -0.054289795880729276 -0.40040000000000003 0.621089310510407 0.6210882485097946 -1.3184778456520885e-06 -0.05430050881381587 -0.4005 0.621110855312988 0.6211098174307492 -1.3178266014823858e-06 -0.05431121997966212 -0.4006 0.6211323958174606 0.6211313820403044 -1.3169474210872334e-06 -0.05432192937821101 -0.40070000000000006 0.6211539320263102 0.621152942336642 -1.3158404313651229e-06 -0.05433263700940573 -0.4008 0.6211754639420214 0.6211744983179455 -1.3145057998764642e-06 -0.05434334287318964 -0.40090000000000003 0.6211969915670774 0.6211960499824002 -1.312943734954608e-06 -0.05435404696950631 -0.401 0.62121851490396 0.6212175973281933 -1.3111544853172674e-06 -0.05436474929829946 -0.4011 0.6212400339551483 0.6212391403535147 -1.3091383403718293e-06 -0.054375449859512974 -0.40120000000000006 0.6212615487231194 0.6212606790565572 -1.3068956300765766e-06 -0.054386148653090965 -0.4013 0.621283059210348 0.6212822134355168 -1.304426724635377e-06 -0.05439684567897773 -0.40140000000000003 0.621304565419305 0.6213037434885933 -1.3017320350805495e-06 -0.05440754093711775 -0.4015 0.6213260673524578 0.6213252692139902 -1.298812012440198e-06 -0.05441823442745563 -0.4016 0.6213475650122696 0.6213467906099159 -1.295667148126789e-06 -0.05442892614993619 -0.40170000000000006 0.6213690584011999 0.6213683076745834 -1.292297973937151e-06 -0.05443961610450446 -0.4018 0.621390547521703 0.6213898204062109 -1.2887050615806306e-06 -0.0544503042911056 -0.40190000000000003 0.6214120323762281 0.6214113288030219 -1.28488902281787e-06 -0.05446099070968499 -0.402 0.6214335129672189 0.6214328328632461 -1.2808505095718292e-06 -0.05447167536018815 -0.4021 0.6214549892971135 0.6214543325851201 -1.2765902133726748e-06 -0.05448235824256085 -0.40220000000000006 0.6214764613683434 0.6214758279668862 -1.2721088654965573e-06 -0.05449303935674898 -0.4023 0.6214979291833338 0.6214973190067943 -1.2674072369933675e-06 -0.054503718702698614 -0.40240000000000004 0.6215193927445024 0.6215188057031016 -1.262486138214891e-06 -0.05451439628035604 -0.4025 0.62154085205426 0.6215402880540737 -1.2573464188980754e-06 -0.054525072089667725 -0.4026 0.6215623071150097 0.6215617660579831 -1.2519889679429852e-06 -0.054535746130580244 -0.40270000000000006 0.6215837579291461 0.6215832397131121 -1.2464147133850467e-06 -0.05454641840304047 -0.4028 0.6216052044990557 0.6216047090177517 -1.240624622061981e-06 -0.05455708890699536 -0.40290000000000004 0.6216266468271157 0.6216261739702018 -1.2346196995582925e-06 -0.05456775764239211 -0.403 0.6216480849156945 0.6216476345687724 -1.2284009901220028e-06 -0.054578424609178104 -0.4031 0.6216695187671507 0.6216690908117832 -1.2219695761650495e-06 -0.054589089807300845 -0.40320000000000006 0.6216909483838331 0.6216905426975649 -1.2153265785130873e-06 -0.054599753236708085 -0.4033 0.6217123737680799 0.621711990224458 -1.2084731560169093e-06 -0.054610414897347685 -0.40340000000000004 0.6217337949222188 0.6217334333908149 -1.2014105053304025e-06 -0.05462107478916774 -0.4035 0.6217552118485665 0.6217548721949993 -1.19413986052197e-06 -0.05463173291211648 -0.4036 0.6217766245494285 0.6217763066353865 -1.1866624930745306e-06 -0.05464238926614241 -0.40370000000000006 0.6217980330270982 0.6217977367103644 -1.1789797119965417e-06 -0.05465304385119412 -0.4038 0.621819437283857 0.6218191624183331 -1.1710928629893314e-06 -0.05466369666722039 -0.40390000000000004 0.6218408373219738 0.6218405837577059 -1.1630033284748542e-06 -0.054674347714170214 -0.404 0.621862233143705 0.6218620007269091 -1.1547125274014025e-06 -0.054684996991992744 -0.4041 0.6218836247512933 0.6218834133243825 -1.1462219150215613e-06 -0.054695644500637325 -0.40420000000000006 0.6219050121469688 0.6219048215485803 -1.1375329825591418e-06 -0.054706290240053516 -0.4043 0.6219263953329471 0.6219262253979707 -1.1286472569038697e-06 -0.054716934210191 -0.40440000000000004 0.6219477743114297 0.6219476248710363 -1.1195663004170964e-06 -0.054727576410999616 -0.4045 0.6219691490846035 0.621969019966275 -1.1102917108207766e-06 -0.05473821684242948 -0.4046 0.621990519654641 0.6219904106821998 -1.1008251206701125e-06 -0.05474885550443081 -0.40470000000000006 0.6220118860236992 0.6220117970173394 -1.0911681970204867e-06 -0.054759492396954004 -0.4048 0.6220332481939198 0.6220331789702385 -1.0813226415662403e-06 -0.054770127519949724 -0.40490000000000004 0.6220546061674285 0.6220545565394578 -1.0712901899745386e-06 -0.05478076087336872 -0.405 0.6220759599463348 0.6220759297235748 -1.061072611358016e-06 -0.05479139245716194 -0.4051 0.622097309532732 0.622097298521184 -1.0506717087188644e-06 -0.054802022271280504 -0.40520000000000006 0.6221186549286966 0.622118662930897 -1.0400893180328996e-06 -0.054812650315675795 -0.4053 0.6221399961362876 0.6221400229513427 -1.0293273080275167e-06 -0.05482327659029926 -0.40540000000000004 0.6221613331575471 0.6221613785811687 -1.0183875800706677e-06 -0.054833901095102625 -0.4055 0.6221826659944989 0.6221827298190399 -1.007272067476972e-06 -0.0548445238300377 -0.4056 0.6222039946491495 0.6222040766636399 -9.959827354522055e-07 -0.05485514479505654 -0.40570000000000006 0.6222253191234867 0.622225419113671 -9.845215808157448e-07 -0.05486576399011137 -0.4058 0.6222466394194792 0.6222467571678552 -9.728906313899444e-07 -0.05487638141515458 -0.40590000000000004 0.6222679555390779 0.6222680908249332 -9.610919458058476e-07 -0.05488699707013875 -0.406 0.6222892674842134 0.6222894200836652 -9.491276130868531e-07 -0.05489761095501662 -0.4061 0.6223105752567974 0.6223107449428322 -9.369997522878926e-07 -0.05490822306974117 -0.40620000000000006 0.6223318788587217 0.6223320654012348 -9.247105122178745e-07 -0.054918833414265456 -0.4063 0.6223531782918578 0.622353381457694 -9.122620709123286e-07 -0.0549294419885428 -0.40640000000000004 0.6223744735580572 0.6223746931110522 -8.996566354391167e-07 -0.05494004879252667 -0.4065 0.6223957646591504 0.6223960003601722 -8.868964412045433e-07 -0.05495065382617068 -0.4066 0.6224170515969474 0.6224173032039387 -8.739837519256e-07 -0.05496125708942872 -0.40670000000000006 0.6224383343732367 0.6224386016412577 -8.609208589915873e-07 -0.05497185858225476 -0.4068 0.6224596129897856 0.6224598956710572 -8.477100811032923e-07 -0.054982458304602966 -0.40690000000000004 0.6224808874483396 0.6224811852922871 -8.343537638011433e-07 -0.05499305625642773 -0.407 0.6225021577506226 0.6225024705039203 -8.208542793541884e-07 -0.05500365243768364 -0.4071 0.6225234238983356 0.6225237513049514 -8.072140259274274e-07 -0.05501424684832537 -0.40720000000000006 0.6225446858931577 0.6225450276943987 -7.934354274152788e-07 -0.05502483948830783 -0.4073 0.6225659437367452 0.6225662996713033 -7.795209330252462e-07 -0.055035430357586096 -0.40740000000000004 0.6225871974307313 0.6225875672347297 -7.654730167783175e-07 -0.05504601945611542 -0.4075 0.6226084469767261 0.622608830383766 -7.512941769260983e-07 -0.05505660678385124 -0.4076 0.6226296923763166 0.6226300891175242 -7.369869356732561e-07 -0.05506719234074917 -0.40770000000000006 0.6226509336310659 0.6226513434351403 -7.225538388999642e-07 -0.05507777612676504 -0.4078 0.6226721707425132 0.6226725933357745 -7.079974553569901e-07 -0.055088358141854754 -0.40790000000000004 0.622693403712174 0.6226938388186118 -6.933203764020179e-07 -0.055098938385974544 -0.408 0.6227146325415388 0.6227150798828618 -6.78525215541681e-07 -0.055109516859080665 -0.4081 0.6227358572320743 0.6227363165277591 -6.63614607904206e-07 -0.05512009356112965 -0.40820000000000006 0.622757077785222 0.6227575487525627 -6.485912097814461e-07 -0.05513066849207818 -0.4083 0.6227782942023992 0.6227787765565584 -6.334576983513251e-07 -0.055141241651883124 -0.40840000000000004 0.6227995064849973 0.6227999999390563 -6.182167708451702e-07 -0.05515181304050152 -0.4085 0.6228207146343827 0.622821218899393 -6.028711443673007e-07 -0.05516238265789058 -0.4086 0.6228419186518965 0.6228424334369305 -5.87423555242772e-07 -0.0551729505040077 -0.40870000000000006 0.6228631185388538 0.6228636435510571 -5.718767586426754e-07 -0.05518351657881043 -0.4088 0.6228843142965443 0.6228848492411871 -5.562335279873931e-07 -0.05519408088225656 -0.40890000000000004 0.6229055059262312 0.6229060505067623 -5.404966546274093e-07 -0.055204643414304005 -0.409 0.6229266934291516 0.62292724734725 -5.246689471771759e-07 -0.05521520417491086 -0.4091 0.6229478768065166 0.6229484397621445 -5.087532309600018e-07 -0.055225763164035414 -0.40920000000000006 0.6229690560595107 0.6229696277509678 -4.927523478415186e-07 -0.05523632038163615 -0.4093 0.622990231189291 0.622990811313268 -4.766691552721136e-07 -0.05524687582767166 -0.40940000000000004 0.6230114021969888 0.6230119904486211 -4.6050652612039666e-07 -0.05525742950210079 -0.4095 0.6230325690837075 0.6230331651566304 -4.4426734807645474e-07 -0.05526798140488252 -0.4096 0.6230537318505243 0.6230543354369268 -4.2795452301347403e-07 -0.05527853153597602 -0.40970000000000006 0.6230748904984884 0.6230755012891688 -4.115709666269174e-07 -0.05528907989534067 -0.4098 0.6230960450286219 0.6230966627130426 -3.9511960785165723e-07 -0.05529962648293594 -0.40990000000000004 0.6231171954419196 0.6231178197082629 -3.7860338826523066e-07 -0.055310171298721594 -0.41 0.6231383417393483 0.6231389722745716 -3.6202526175477256e-07 -0.055320714342657465 -0.4101 0.6231594839218475 0.6231601204117394 -3.453881937606762e-07 -0.05533125561470364 -0.41020000000000006 0.6231806219903279 0.6231812641195652 -3.2869516095740403e-07 -0.055341795114820305 -0.4103 0.6232017559456733 0.6232024033978762 -3.119491505387817e-07 -0.05535233284296792 -0.41040000000000004 0.6232228857887389 0.6232235382465284 -2.95153159822481e-07 -0.05536286879910705 -0.4105 0.6232440115203519 0.6232446686654061 -2.783101956324585e-07 -0.05537340298319848 -0.4106 0.6232651331413109 0.6232657946544221 -2.6142327377853825e-07 -0.0553839353952031 -0.41070000000000007 0.6232862506523866 0.6232869162135186 -2.4449541857068935e-07 -0.05539446603508206 -0.4108 0.623307364054321 0.6233080333426664 -2.2752966214595327e-07 -0.055404994902796656 -0.41090000000000004 0.6233284733478276 0.6233291460418651 -2.1052904414231577e-07 -0.05541552199830835 -0.411 0.6233495785335915 0.6233502543111433 -1.9349661089379522e-07 -0.05542604732157879 -0.4111 0.6233706796122689 0.623371358150559 -1.7643541512166183e-07 -0.05543657087256979 -0.41120000000000007 0.6233917765844875 0.6233924575601988 -1.5934851523707882e-07 -0.05544709265124337 -0.4113 0.6234128694508462 0.623413552540179 -1.422389748310937e-07 -0.05545761265756169 -0.41140000000000004 0.623433958211915 0.6234346430906452 -1.2510986212993513e-07 -0.055468130891487104 -0.4115 0.6234550428682355 0.6234557292117717 -1.079642494433708e-07 -0.05547864735298215 -0.4116 0.6234761234203194 0.6234768109037628 -9.080521264949459e-08 -0.055489162042009536 -0.41170000000000007 0.62349719986865 0.6234978881668518 -7.363583058236922e-08 -0.05549967495853212 -0.4118 0.6235182722136821 0.6235189610013014 -5.645918452028276e-08 -0.05551018610251297 -0.41190000000000004 0.6235393404558409 0.6235400294074038 -3.927835760461629e-08 -0.05552069547391533 -0.412 0.6235604045955228 0.6235610933854809 -2.209643431812583e-08 -0.055531203072702595 -0.4121 0.623581464633095 0.6235821529358834 -4.91649989773843e-09 -0.05554170889883834 -0.41220000000000007 0.6236025205688962 0.6236032080589922 1.2258360199308982e-08 -0.055552212952286364 -0.4123 0.6236235724032353 0.6236242587552172 2.9425060853183194e-08 -0.05556271523301057 -0.41240000000000004 0.623644620136393 0.6236453050249982 4.658051784567352e-08 -0.05557321574097508 -0.4125 0.6236656637686199 0.6236663468688037 6.372164840229289e-08 -0.05558371447614418 -0.4126 0.6236867033001385 0.6236873842871324 8.084537176517026e-08 -0.05559421143848231 -0.41270000000000007 0.6237077387311423 0.6237084172805122 9.794860971953923e-08 -0.055604706627954165 -0.4128 0.6237287700617953 0.6237294458495002 1.1502828717313562e-07 -0.055615200044524526 -0.41290000000000004 0.6237497972922327 0.6237504699946832 1.3208133270437017e-07 -0.05562569168815839 -0.413 0.6237708204225609 0.6237714897166771 1.4910467911743996e-07 -0.05563618155882091 -0.4131 0.6237918394528574 0.6237925050161272 1.6609526397315388e-07 -0.05564666965647746 -0.41320000000000007 0.623812854383171 0.623813515893708 1.83050030182208e-07 -0.05565715598109351 -0.4133 0.6238338652135214 0.6238345223501234 1.9996592651866374e-07 -0.05566764053263479 -0.41340000000000005 0.6238548719439 0.6238555243861063 2.1683990820281496e-07 -0.055678123311067175 -0.4135 0.623875874574269 0.6238765220024186 2.336689374007883e-07 -0.05568860431635669 -0.4136 0.6238968731045624 0.6238975151998516 2.504499838421048e-07 -0.05569908354846953 -0.41370000000000007 0.6239178675346855 0.6239185039792252 2.671800253470358e-07 -0.05570956100737212 -0.4138 0.6239388578645148 0.6239394883413885 2.838560482568142e-07 -0.05572003669303099 -0.41390000000000005 0.6239598440938992 0.6239604682872191 3.0047504820385207e-07 -0.055730510605412925 -0.414 0.6239808262226589 0.6239814438176232 3.1703403045174605e-07 -0.0557409827444848 -0.4141 0.6240018042505857 0.6240024149335365 3.335300105544725e-07 -0.05575145311021375 -0.41420000000000007 0.6240227781774436 0.6240233816359222 3.4996001482823225e-07 -0.055761921702567 -0.4143 0.6240437480029685 0.6240443439257723 3.663210808996231e-07 -0.055772388521512055 -0.41440000000000005 0.6240647137268683 0.6240653018041077 3.826102583370794e-07 -0.05578285356701649 -0.4145 0.6240856753488231 0.6240862552719766 3.9882460903251093e-07 -0.055793316839048084 -0.4146 0.6241066328684854 0.6241072043304557 4.1496120786743695e-07 -0.05580377833757482 -0.41470000000000007 0.6241275862854803 0.6241281489806499 4.310171431154419e-07 -0.05581423806256483 -0.4148 0.624148535599405 0.6241490892236918 4.4698951712218715e-07 -0.05582469601398642 -0.41490000000000005 0.62416948080983 0.6241700250607415 4.6287544668011105e-07 -0.05583515219180812 -0.415 0.6241904219162986 0.6241909564929871 4.786720636529296e-07 -0.055845606595998576 -0.4151 0.624211358918326 0.6242118835216439 4.943765154891144e-07 -0.055856059226526616 -0.41520000000000007 0.6242322918154024 0.6242328061479542 5.099859656521044e-07 -0.055866510083361236 -0.4153 0.6242532206069893 0.6242537243731883 5.254975942586837e-07 -0.055876959166471674 -0.41540000000000005 0.6242741452925233 0.6242746381986424 5.409085984120487e-07 -0.05588740647582725 -0.4155 0.6242950658714135 0.6242955476256403 5.5621619300672e-07 -0.0558978520113975 -0.4156 0.6243159823430432 0.6243164526555325 5.714176109505864e-07 -0.055908295773152164 -0.41570000000000007 0.6243368947067696 0.6243373532896954 5.86510103789406e-07 -0.05591873776106108 -0.4158 0.6243578029619239 0.6243582495295323 6.014909421508952e-07 -0.05592917797509435 -0.41590000000000005 0.6243787071078116 0.6243791413764723 6.163574163969843e-07 -0.05593961641522216 -0.416 0.624399607143713 0.6244000288319707 6.311068368597406e-07 -0.055950053081414965 -0.4161 0.6244205030688825 0.624420911897508 6.457365346324018e-07 -0.055960487973643315 -0.41620000000000007 0.6244413948825498 0.6244417905745913 6.602438618052986e-07 -0.055970921091877956 -0.4163 0.6244622825839193 0.6244626648647518 6.74626191965455e-07 -0.05598135243608981 -0.41640000000000005 0.624483166172171 0.624483534769547 6.888809208904778e-07 -0.05599178200624999 -0.4165 0.6245040456464603 0.6245044002905586 7.030054667844787e-07 -0.05600220980232974 -0.4166 0.6245249210059183 0.6245252614293935 7.169972709442085e-07 -0.05601263582430058 -0.41670000000000007 0.6245457922496517 0.6245461181876828 7.308537981476348e-07 -0.05602306007213407 -0.4168 0.6245666593767434 0.6245669705670822 7.44572536875987e-07 -0.05603348254580201 -0.41690000000000005 0.6245875223862529 0.624587818569271 7.581510002574454e-07 -0.056043903245276354 -0.417 0.6246083812772163 0.6246086621959531 7.715867262059195e-07 -0.056054322170529275 -0.4171 0.6246292360486463 0.6246295014488554 7.848772777263591e-07 -0.05606473932153309 -0.41720000000000007 0.6246500866995324 0.6246503363297283 7.980202437474215e-07 -0.056075154698260236 -0.4173 0.6246709332288418 0.6246711668403456 8.110132394822944e-07 -0.056085568300683425 -0.41740000000000005 0.6246917756355193 0.6246919929825036 8.238539065397177e-07 -0.05609598012877545 -0.4175 0.6247126139184871 0.6247128147580212 8.365399136456286e-07 -0.05610639018250935 -0.4176 0.6247334480766458 0.6247336321687401 8.490689570872512e-07 -0.056116798461858276 -0.41770000000000007 0.6247542781088741 0.6247544452165241 8.614387608241181e-07 -0.0561272049667956 -0.4178 0.6247751040140295 0.6247752539032583 8.736470774595162e-07 -0.05613760969729486 -0.41790000000000005 0.6247959257909479 0.6247960582308498 8.856916880739529e-07 -0.05614801265332971 -0.418 0.6248167434384447 0.6248168582012271 8.975704029745568e-07 -0.05615841383487402 -0.4181 0.6248375569553145 0.6248376538163395 9.092810619448777e-07 -0.056168813241901885 -0.41820000000000007 0.6248583663403319 0.6248584450781569 9.208215348277538e-07 -0.056179210874387486 -0.4183 0.6248791715922509 0.6248792319886702 9.321897216918451e-07 -0.05618960673230522 -0.41840000000000005 0.6248999727098061 0.62490001454989 9.433835532757229e-07 -0.05620000081562965 -0.4185 0.6249207696917125 0.6249207927638469 9.544009915429807e-07 -0.056210393124335484 -0.4186 0.6249415625366661 0.6249415666325913 9.652400299597907e-07 -0.056220783658397645 -0.41870000000000007 0.6249623512433439 0.6249623361581924 9.758986936614367e-07 -0.056231172417791186 -0.4188 0.6249831358104041 0.6249831013427393 9.863750400906923e-07 -0.056241559402491405 -0.41890000000000005 0.6250039162364869 0.6250038621883389 9.966671591921106e-07 -0.05625194461247371 -0.419 0.6250246925202145 0.6250246186971171 1.0067731739671348e-06 -0.05626232804771367 -0.41910000000000003 0.6250454646601914 0.6250453708712173 1.0166912403630768e-06 -0.056272709708187055 -0.4192000000000001 0.6250662326550047 0.6250661187128013 1.0264195482445615e-06 -0.056283089593869844 -0.4193 0.6250869965032247 0.6250868622240475 1.035956321560061e-06 -0.056293467704738115 -0.41940000000000005 0.6251077562034046 0.6251076014071524 1.0452998180365825e-06 -0.05630384404076812 -0.4195 0.6251285117540816 0.6251283362643285 1.0544483302898922e-06 -0.056314218601936375 -0.41960000000000003 0.6251492631537767 0.625149066797805 1.0634001858522701e-06 -0.056324591388219436 -0.4197000000000001 0.6251700104009954 0.6251697930098276 1.0721537474223108e-06 -0.05633496239959418 -0.4198 0.6251907534942276 0.6251905149026573 1.08070741319799e-06 -0.05634533163603755 -0.41990000000000005 0.6252114924319481 0.6252112324785707 1.0890596171819755e-06 -0.05635569909752667 -0.42 0.625232227212617 0.6252319457398596 1.0972088296812288e-06 -0.05636606478403886 -0.42010000000000003 0.6252529578346802 0.6252526546888306 1.1051535572792481e-06 -0.056376428695551595 -0.4202 0.6252736842965695 0.6252733593278044 1.1128923429748472e-06 -0.05638679083204254 -0.4203 0.6252944065967032 0.6252940596591163 1.1204237670425776e-06 -0.056397151193489516 -0.42040000000000005 0.625315124733486 0.6253147556851152 1.1277464470604848e-06 -0.05640750977987056 -0.4205 0.6253358387053096 0.6253354474081629 1.134859037882352e-06 -0.056417866591163816 -0.42060000000000003 0.6253565485105537 0.6253561348306348 1.1417602319152564e-06 -0.05642822162734759 -0.4207 0.6253772541475849 0.6253768179549186 1.1484487599522364e-06 -0.05643857488840044 -0.4208 0.6253979556147585 0.6253974967834146 1.1549233908392242e-06 -0.05644892637430106 -0.42090000000000005 0.625418652910418 0.6254181713185345 1.1611829316970912e-06 -0.05645927608502824 -0.421 0.625439346032896 0.6254388415627024 1.1672262284490031e-06 -0.05646962402056106 -0.42110000000000003 0.6254600349805141 0.6254595075183529 1.1730521659036874e-06 -0.05647997018087875 -0.4212 0.6254807197515833 0.6254801691879319 1.178659668005233e-06 -0.056490314565960625 -0.4213 0.6255014003444048 0.6255008265738955 1.1840476979163572e-06 -0.05650065717578623 -0.42140000000000005 0.6255220767572702 0.6255214796787099 1.1892152583514726e-06 -0.0565109980103353 -0.4215 0.6255427489884615 0.6255421285048508 1.194161391632198e-06 -0.05652133706958767 -0.42160000000000003 0.6255634170362523 0.6255627730548039 1.198885180075937e-06 -0.05653167435352344 -0.4217 0.6255840808989068 0.6255834133310634 1.2033857460513886e-06 -0.056542009862122794 -0.4218 0.6256047405746821 0.6256040493361319 1.207662252006303e-06 -0.056552343595366164 -0.42190000000000005 0.6256253960618265 0.6256246810725204 1.2117139008838151e-06 -0.05656267555323407 -0.422 0.6256460473585814 0.6256453085427482 1.2155399359836672e-06 -0.056573005735707296 -0.42210000000000003 0.6256666944631815 0.6256659317493414 1.2191396414895639e-06 -0.05658333414276673 -0.4222 0.6256873373738538 0.625686550694833 1.2225123423581508e-06 -0.05659366077439343 -0.4223 0.6257079760888202 0.6257071653817634 1.2256574044855473e-06 -0.05660398563056865 -0.42240000000000005 0.6257286106062963 0.6257277758126785 1.228574234762858e-06 -0.0566143087112738 -0.4225 0.625749240924492 0.6257483819901305 1.2312622811871954e-06 -0.05662463001649048 -0.42260000000000003 0.6257698670416126 0.6257689839166772 1.2337210334723014e-06 -0.05663494954620044 -0.4227 0.6257904889558583 0.6257895815948811 1.235950022437926e-06 -0.05664526730038562 -0.4228 0.625811106665425 0.6258101750273095 1.2379488202596267e-06 -0.05665558327902809 -0.42290000000000005 0.6258317201685053 0.6258307642165339 1.239717040829591e-06 -0.05666589748211009 -0.423 0.6258523294632876 0.6258513491651305 1.2412543398399034e-06 -0.05667620990961414 -0.42310000000000003 0.6258729345479578 0.6258719298756776 1.2425604145049896e-06 -0.05668652056152277 -0.4232 0.6258935354206985 0.6258925063507579 1.2436350040612165e-06 -0.056696829437818785 -0.4233 0.6259141320796906 0.6259130785929562 1.244477889433826e-06 -0.056707136538485185 -0.42340000000000005 0.6259347245231126 0.6259336466048595 1.2450888934867343e-06 -0.05671744186350497 -0.4235 0.6259553127491417 0.625954210389057 1.2454678809947772e-06 -0.05672774541286155 -0.42360000000000003 0.6259758967559541 0.6259747699481397 1.245614758865754e-06 -0.0567380471865383 -0.4237 0.625996476541725 0.6259953252846988 1.2455294759738944e-06 -0.05674834718451889 -0.4238 0.6260170521046295 0.626015876401327 1.2452120231043473e-06 -0.05675864540678708 -0.42390000000000005 0.6260376234428429 0.626036423300617 1.2446624333140033e-06 -0.05676894185332684 -0.424 0.6260581905545404 0.6260569659851618 1.2438807813486275e-06 -0.05677923652412229 -0.42410000000000003 0.6260787534378989 0.6260775044575533 1.2428671841147043e-06 -0.05678952941915776 -0.4242 0.6260993120910963 0.6260980387203826 1.24162180079046e-06 -0.05679982053841773 -0.4243 0.626119866512312 0.6261185687762403 1.2401448324927955e-06 -0.05681010988188683 -0.42440000000000005 0.6261404166997276 0.6261390946277141 1.2384365221385085e-06 -0.056820397449549837 -0.4245 0.6261609626515272 0.6261596162773908 1.2364971546108272e-06 -0.05683068324139178 -0.42460000000000003 0.6261815043658977 0.6261801337278539 1.2343270568149212e-06 -0.05684096725739777 -0.4247 0.6262020418410297 0.6262006469816843 1.2319265975391236e-06 -0.05685124949755316 -0.4248 0.6262225750751167 0.6262211560414596 1.2292961872883978e-06 -0.056861529961843404 -0.42490000000000006 0.6262431040663573 0.6262416609097536 1.2264362784231153e-06 -0.05687180865025421 -0.425 0.6262636288129536 0.6262621615891362 1.2233473649370108e-06 -0.0568820855627713 -0.42510000000000003 0.6262841493131135 0.6262826580821726 1.2200299821241156e-06 -0.0568923606993808 -0.4252 0.626304665565049 0.6263031503914234 1.2164847071616247e-06 -0.05690263406006875 -0.4253 0.6263251775669793 0.626323638519444 1.2127121583327405e-06 -0.05691290564482157 -0.42540000000000006 0.6263456853171281 0.6263441224687833 1.2087129954430065e-06 -0.05692317545362568 -0.4255 0.6263661888137267 0.6263646022419855 1.2044879195427516e-06 -0.05693344348646783 -0.42560000000000003 0.6263866880550131 0.6263850778415873 1.200037672538512e-06 -0.056943709743334826 -0.4257 0.6264071830392319 0.6264055492701188 1.1953630373040536e-06 -0.05695397422421366 -0.4258 0.6264276737646358 0.626426016530103 1.1904648376248606e-06 -0.05696423692909152 -0.42590000000000006 0.6264481602294856 0.6264464796240552 1.185343937976091e-06 -0.05697449785795573 -0.426 0.6264686424320502 0.6264669385544825 1.1800012432450213e-06 -0.0569847570107938 -0.42610000000000003 0.626489120370608 0.6264873933238843 1.1744376987865568e-06 -0.05699501438759345 -0.4262 0.6265095940434453 0.6265078439347501 1.1686542902566988e-06 -0.05700526998834248 -0.4263 0.6265300634488593 0.6265282903895611 1.162652043112944e-06 -0.05701552381302891 -0.42640000000000006 0.6265505285851565 0.6265487326907888 1.1564320230028624e-06 -0.057025775861640954 -0.4265 0.6265709894506536 0.6265691708408947 1.1499953347648972e-06 -0.057036026134166896 -0.42660000000000003 0.6265914460436783 0.6265896048423296 1.1433431230667424e-06 -0.057046274630595334 -0.4267 0.6266118983625695 0.6266100346975341 1.1364765720445202e-06 -0.05705652135091488 -0.4268 0.6266323464056771 0.6266304604089379 1.1293969045256258e-06 -0.05706676629511447 -0.42690000000000006 0.6266527901713632 0.6266508819789587 1.12210538244506e-06 -0.05707700946318305 -0.427 0.626673229658002 0.6266712994100025 1.1146033063180738e-06 -0.05708725085510984 -0.42710000000000004 0.6266936648639803 0.6266917127044637 1.1068920151569017e-06 -0.05709749047088422 -0.4272 0.6267140957876978 0.6267121218647235 1.0989728859711612e-06 -0.05710772831049569 -0.4273 0.6267345224275676 0.6267325268931505 1.0908473337956082e-06 -0.057117964373933953 -0.42740000000000006 0.6267549447820161 0.6267529277921 1.0825168115513595e-06 -0.05712819866118884 -0.4275 0.6267753628494842 0.6267733245639137 1.0739828094075143e-06 -0.05713843117225042 -0.42760000000000004 0.6267957766284269 0.626793717210919 1.0652468547811544e-06 -0.05714866190710885 -0.4277 0.6268161861173142 0.6268141057354295 1.0563105120597882e-06 -0.05715889086575452 -0.4278 0.6268365913146309 0.6268344901397438 1.0471753821850172e-06 -0.05716911804817797 -0.42790000000000006 0.6268569922188774 0.6268548704261453 1.0378431025415136e-06 -0.057179343454369896 -0.428 0.6268773888285698 0.6268752465969023 1.0283153464574202e-06 -0.05718956708432113 -0.42810000000000004 0.6268977811422403 0.6268956186542674 1.0185938229267943e-06 -0.0571997889380227 -0.4282 0.6269181691584375 0.6269159866004766 1.0086802767761416e-06 -0.05721000901546583 -0.4283 0.6269385528757273 0.6269363504377503 9.985764876374592e-07 -0.05722022731664187 -0.42840000000000006 0.6269589322926922 0.6269567101682915 9.8828427036457e-07 -0.05723044384154237 -0.4285 0.6269793074079322 0.6269770657942862 9.778054740339215e-07 -0.05724065859015899 -0.42860000000000004 0.6269996782200656 0.6269974173179036 9.671419819168303e-07 -0.05725087156248365 -0.4287 0.6270200447277285 0.627017764741294 9.562957113129489e-07 -0.057261082758508365 -0.4288 0.6270404069295754 0.627038108066591 9.45268612911887e-07 -0.057271292178225346 -0.42890000000000006 0.6270607648242797 0.6270584472959086 9.340626705711674e-07 -0.057281499821626926 -0.429 0.6270811184105337 0.6270787824313427 9.226799009831588e-07 -0.05729170568870565 -0.42910000000000004 0.6271014676870494 0.6270991134749702 9.111223533975199e-07 -0.05730190977945421 -0.4292 0.6271218126525583 0.6271194404288485 8.993921091493551e-07 -0.057312112093865476 -0.4293 0.627142153305812 0.6271397632950155 8.874912811041025e-07 -0.05732231263193249 -0.42940000000000006 0.6271624896455826 0.627160082075489 8.754220137130453e-07 -0.057332511393648436 -0.4295 0.6271828216706627 0.6271803967722669 8.631864822639113e-07 -0.05734270837900673 -0.42960000000000004 0.6272031493798658 0.6272007073873259 8.507868926865836e-07 -0.05735290358800082 -0.4297 0.6272234727720263 0.6272210139226225 8.382254809979894e-07 -0.05736309702062445 -0.4298 0.6272437918460005 0.6272413163800921 8.25504512969033e-07 -0.05737328867687146 -0.42990000000000006 0.6272641066006668 0.6272616147616481 8.126262837915288e-07 -0.057383478556735916 -0.43 0.6272844170349248 0.6272819090691829 7.995931177173787e-07 -0.05739366666021198 -0.43010000000000004 0.6273047231476973 0.6273021993045664 7.864073675867278e-07 -0.05740385298729403 -0.4302 0.6273250249379292 0.6273224854696466 7.730714142173412e-07 -0.05741403753797658 -0.4303 0.6273453224045886 0.627342767566249 7.595876661270484e-07 -0.05742422031225435 -0.43040000000000006 0.6273656155466665 0.6273630455961762 7.459585590341433e-07 -0.05743440131012219 -0.4305 0.6273859043631775 0.6273833195612077 7.321865556908502e-07 -0.05744458053157512 -0.43060000000000004 0.6274061888531597 0.6274035894630998 7.182741451339236e-07 -0.05745475797660831 -0.4307 0.6274264690156754 0.6274238553035856 7.042238423793368e-07 -0.05746493364521718 -0.4308 0.6274467448498104 0.6274441170843739 6.900381877839035e-07 -0.057475107537397145 -0.43090000000000006 0.627467016354676 0.6274643748071494 6.757197469620113e-07 -0.05748527965314396 -0.431 0.6274872835294074 0.6274846284735732 6.612711099251989e-07 -0.057495449992453485 -0.43110000000000004 0.6275075463731649 0.6275048780852812 6.466948908878667e-07 -0.05750561855532175 -0.4312 0.6275278048851338 0.6275251236438851 6.319937276844101e-07 -0.05751578534174489 -0.4313 0.627548059064525 0.6275453651509711 6.171702812418633e-07 -0.05752595035171927 -0.43140000000000006 0.6275683089105748 0.6275656026081007 6.022272352051994e-07 -0.057536113585241425 -0.4315 0.6275885544225454 0.6275858360168097 5.871672954793627e-07 -0.057546275042308005 -0.43160000000000004 0.6276087955997247 0.6276060653786083 5.719931896047692e-07 -0.057556434722915856 -0.43170000000000003 0.6276290324414273 0.627626290694981 5.567076663270942e-07 -0.05756659262706202 -0.4318 0.6276492649469936 0.6276465119673863 5.413134951115506e-07 -0.05757674875474361 -0.43190000000000006 0.6276694931157912 0.6276667291972563 5.258134656849212e-07 -0.05758690310595802 -0.432 0.6276897169472142 0.627686942385997 5.102103874943253e-07 -0.05759705568070274 -0.43210000000000004 0.627709936440684 0.6277071515349874 4.945070892631298e-07 -0.05760720647897544 -0.43220000000000003 0.6277301515956487 0.6277273566455799 4.787064182137923e-07 -0.05761735550077397 -0.4323 0.627750362411584 0.6277475577190996 4.62811239929084e-07 -0.057627502746096286 -0.4324 0.6277705688879933 0.6277677547568452 4.468244376304442e-07 -0.057637648214940586 -0.4325 0.6277907710244075 0.6277879477600874 4.307489116367469e-07 -0.05764779190730517 -0.43260000000000004 0.6278109688203857 0.6278081367300696 4.1458757883694464e-07 -0.05765793382318858 -0.43270000000000003 0.6278311622755142 0.6278283216680078 3.983433723292462e-07 -0.05766807396258942 -0.4328 0.6278513513894082 0.6278485025750898 3.82019240671716e-07 -0.05767821232550653 -0.4329 0.6278715361617111 0.6278686794524757 3.656181475353293e-07 -0.05768834891193889 -0.433 0.6278917165920949 0.6278888523012975 3.491430710378385e-07 -0.05769848372188568 -0.43310000000000004 0.6279118926802598 0.627909021122659 3.325970032719283e-07 -0.05770861675534618 -0.43320000000000003 0.6279320644259354 0.6279291859176352 3.1598294970847096e-07 -0.057718748012319854 -0.4333 0.6279522318288794 0.6279493466872732 2.993039286969257e-07 -0.05772887749280639 -0.4334 0.6279723948888791 0.6279695034325912 2.8256297095186067e-07 -0.057739005196805575 -0.4335 0.6279925536057507 0.6279896561545787 2.6576311878967473e-07 -0.05774913112431734 -0.43360000000000004 0.6280127079793395 0.6280098048541962 2.489074258996138e-07 -0.057759255275341884 -0.43370000000000003 0.6280328580095205 0.6280299495323758 2.319989566013092e-07 -0.05776937764987949 -0.4338 0.6280530036961977 0.6280500901900196 2.1504078524109405e-07 -0.057779498247930584 -0.4339 0.6280731450393049 0.6280702268280014 1.9803599579648612e-07 -0.05778961706949581 -0.434 0.6280932820388057 0.6280903594471654 1.8098768118923747e-07 -0.057799734114576 -0.43410000000000004 0.628113414694693 0.6281104880483264 1.6389894277879513e-07 -0.05780984938317203 -0.43420000000000003 0.62813354300699 0.6281306126322698 1.4677288977249514e-07 -0.0578199628752851 -0.4343 0.6281536669757493 0.6281507331997513 1.2961263868432882e-07 -0.05783007459091641 -0.4344 0.6281737866010538 0.6281708497514976 1.1242131271391176e-07 -0.05784018453006745 -0.4345 0.6281939018830164 0.6281909622882055 9.520204123300569e-08 -0.05785029269273981 -0.43460000000000004 0.6282140128217798 0.6282110708105417 7.795795923387638e-08 -0.0578603990789353 -0.43470000000000003 0.628234119417517 0.6282311753191437 6.069220668050712e-08 -0.05787050368865582 -0.4348 0.628254221670431 0.6282512758146191 4.340792800205939e-08 -0.05788060652190348 -0.4349 0.6282743195807553 0.6282713722975454 2.6108271506536385e-08 -0.05789070757868051 -0.435 0.6282944131487537 0.6282914647684704 8.796388789242271e-09 -0.05790080685898938 -0.43510000000000004 0.62831450237472 0.6283115532279119 -8.524565836207088e-09 -0.05791090436283265 -0.43520000000000003 0.6283345872589785 0.6283316376763578 -2.5851435904271358e-08 -0.05792100009021309 -0.4353 0.6283546678018838 0.6283517181142662 -4.318106337341393e-08 -0.057931094041133585 -0.4354 0.6283747440038207 0.628371794542065 -6.051028921113741e-08 -0.0579411862155972 -0.4355 0.6283948158652046 0.628391866960152 -7.783595396514131e-08 -0.05795127661360722 -0.43560000000000004 0.6284148833864813 0.6284119353688955 -9.515489833925028e-08 -0.05796136523516702 -0.43570000000000003 0.6284349465681267 0.6284319997686334 -1.1246396377541379e-07 -0.05797145208028018 -0.4358 0.6284550054106472 0.6284520601596736 -1.2975999302659857e-07 -0.05798153714895039 -0.4359 0.6284750599145797 0.6284721165422941 -1.47039830717538e-07 -0.05799162044118155 -0.436 0.6284951100804913 0.6284921689167432 -1.6430032396749783e-07 -0.058001701956977736 -0.43610000000000004 0.6285151559089796 0.6285122172832388 -1.8153832290895844e-07 -0.05801178169634318 -0.43620000000000003 0.6285351974006719 0.6285322616419694 -1.9875068131211537e-07 -0.05802185965928223 -0.4363 0.6285552345562266 0.6285523019930933 -2.1593425713478664e-07 -0.058031935845799444 -0.4364 0.6285752673763315 0.628572338336739 -2.330859131122187e-07 -0.058042010255899515 -0.4365 0.6285952958617052 0.6285923706730049 -2.5020251729485077e-07 -0.05805208288958729 -0.43660000000000004 0.628615320013096 0.6286123990019603 -2.6728094366240684e-07 -0.058062153746867795 -0.43670000000000003 0.6286353398312824 0.6286324233236444 -2.8431807268941567e-07 -0.05807222282774627 -0.4368 0.628655355317073 0.6286524436380669 -3.0131079190032217e-07 -0.058082290132228 -0.4369 0.6286753664713061 0.6286724599452079 -3.18255996424599e-07 -0.058092355660318507 -0.437 0.6286953732948501 0.6286924722450181 -3.3515058965594147e-07 -0.05810241941202349 -0.43710000000000004 0.6287153757886031 0.6287124805374187 -3.5199148372411226e-07 -0.05811248138734879 -0.43720000000000003 0.6287353739534931 0.6287324848223016 -3.6877560007780863e-07 -0.05812254158630042 -0.4373 0.6287553677904772 0.6287524850995294 -3.854998700883461e-07 -0.05813260000888448 -0.4374 0.6287753573005426 0.6287724813689355 -4.0216123553538097e-07 -0.058142656655107344 -0.4375 0.6287953424847056 0.6287924736303244 -4.1875664925916656e-07 -0.0581527115249755 -0.43760000000000004 0.6288153233440117 0.6288124618834718 -4.352830756948478e-07 -0.058162764618495566 -0.43770000000000003 0.6288352998795357 0.6288324461281243 -4.5173749139981734e-07 -0.05817281593567434 -0.4378 0.6288552720923818 0.6288524263639996 -4.6811688554637687e-07 -0.05818286547651881 -0.4379 0.6288752399836827 0.6288724025907875 -4.844182607544045e-07 -0.05819291324103613 -0.438 0.6288952035546005 0.6288923748081483 -5.006386332301327e-07 -0.058202959229233554 -0.43810000000000004 0.6289151628063256 0.6289123430157153 -5.16775033682082e-07 -0.058213003441118585 -0.43820000000000003 0.6289351177400768 0.6289323072130922 -5.328245076263727e-07 -0.05822304587669878 -0.4383 0.6289550683571019 0.6289522673998557 -5.487841160389806e-07 -0.05823308653598194 -0.4384 0.6289750146586766 0.6289722235755539 -5.646509358692153e-07 -0.058243125418976 -0.4385 0.6289949566461046 0.6289921757397077 -5.804220605393207e-07 -0.05825316252568905 -0.43860000000000005 0.6290148943207179 0.6290121238918097 -5.960946005550971e-07 -0.05826319785612937 -0.43870000000000003 0.6290348276838764 0.6290320680313256 -6.116656840748913e-07 -0.05827323141030536 -0.4388 0.6290547567369674 0.6290520081576937 -6.271324572842962e-07 -0.058283263188225604 -0.4389 0.6290746814814054 0.6290719442703255 -6.424920851177962e-07 -0.05829329318989886 -0.439 0.6290946019186329 0.6290918763686046 -6.577417515224449e-07 -0.05830332141533399 -0.43910000000000005 0.629114518050119 0.6291118044518889 -6.728786602211434e-07 -0.05831334786454008 -0.43920000000000003 0.62913442987736 0.6291317285195093 -6.879000351428521e-07 -0.05832337253752639 -0.4393 0.6291543374018789 0.6291516485707702 -7.028031207834129e-07 -0.058333395434302285 -0.4394 0.6291742406252248 0.62917156460495 -7.175851830382163e-07 -0.05834341655487727 -0.4395 0.6291941395489734 0.6291914766213014 -7.322435094103685e-07 -0.058353435899261064 -0.43960000000000005 0.6292140341747272 0.6292113846190507 -7.467754096213142e-07 -0.058363453467463605 -0.43970000000000004 0.6292339245041138 0.6292312885973992 -7.611782162353364e-07 -0.05837346925949484 -0.4398 0.6292538105387865 0.6292511885555226 -7.754492849232353e-07 -0.058383483275364995 -0.4399 0.6292736922804245 0.6292710844925717 -7.895859952533613e-07 -0.058393495515084395 -0.44 0.6292935697307321 0.6292909764076723 -8.035857506083488e-07 -0.05840350597866359 -0.44010000000000005 0.6293134428914384 0.6293108642999256 -8.174459792953392e-07 -0.05841351466611322 -0.44020000000000004 0.6293333117642976 0.629330748168408 -8.311641347125143e-07 -0.05842352157744407 -0.4403 0.6293531763510882 0.6293506280121723 -8.447376960152297e-07 -0.058433526712667216 -0.4404 0.6293730366536133 0.6293705038302471 -8.581641681437713e-07 -0.05844353007179374 -0.4405 0.6293928926736998 0.6293903756216369 -8.714410828780661e-07 -0.05845353165483497 -0.44060000000000005 0.6294127444131984 0.6294102433853235 -8.845659987821719e-07 -0.05846353146180236 -0.44070000000000004 0.6294325918739834 0.6294301071202653 -8.975365020924553e-07 -0.05847352949270756 -0.4408 0.6294524350579526 0.6294499668253974 -9.103502067453473e-07 -0.058483525747562354 -0.4409 0.6294722739670263 0.629469822499633 -9.230047550712328e-07 -0.058493520226378694 -0.441 0.629492108603148 0.629489674141862 -9.35497818294051e-07 -0.058503512929168694 -0.44110000000000005 0.6295119389682835 0.629509521750953 -9.478270968366065e-07 -0.05851350385594461 -0.44120000000000004 0.6295317650644208 0.6295293653257521 -9.599903205981253e-07 -0.05852349300671883 -0.4413 0.6295515868935698 0.6295492048650845 -9.71985249842433e-07 -0.058533480381504015 -0.4414 0.6295714044577619 0.6295690403677537 -9.83809675086933e-07 -0.05854346598031285 -0.4415 0.6295912177590501 0.6295888718325425 -9.954614177409837e-07 -0.058553449803158276 -0.44160000000000005 0.6296110267995081 0.6296086992582126 -1.0069383304667223e-06 -0.05856343185005333 -0.44170000000000004 0.6296308315812306 0.6296285226435061 -1.0182382979284643e-06 -0.05857341212101124 -0.4418 0.6296506321063324 0.6296483419871444 -1.0293592366816817e-06 -0.05858339061604541 -0.4419 0.6296704283769492 0.6296681572878292 -1.0402990958391367e-06 -0.05859336733516938 -0.442 0.6296902203952357 0.629687968544243 -1.0510558572096595e-06 -0.058603342278396836 -0.44210000000000005 0.629710008163366 0.6297077757550491 -1.0616275361308158e-06 -0.058613315445741644 -0.44220000000000004 0.629729791683534 0.6297275789188916 -1.0720121812191064e-06 -0.05862328683721779 -0.4423 0.6297495709579524 0.629747378034397 -1.082207875285901e-06 -0.058633256452839524 -0.4424 0.6297693459888518 0.6297671731001725 -1.0922127355594835e-06 -0.0586432242926211 -0.4425 0.6297891167784817 0.6297869641148084 -1.1020249138515847e-06 -0.05865319035657707 -0.44260000000000005 0.6298088833291091 0.629806751076877 -1.1116425968904498e-06 -0.05866315464472208 -0.44270000000000004 0.6298286456430187 0.6298265339849337 -1.1210640069037048e-06 -0.05867311715707096 -0.4428 0.6298484037225122 0.6298463128375166 -1.1302874018681575e-06 -0.05868307789363863 -0.4429 0.6298681575699082 0.6298660876331479 -1.139311075759597e-06 -0.058693036854440245 -0.443 0.6298879071875422 0.6298858583703332 -1.148133358885861e-06 -0.05870299403949111 -0.44310000000000005 0.6299076525777654 0.6299056250475624 -1.1567526183586807e-06 -0.05871294944880665 -0.44320000000000004 0.6299273937429448 0.6299253876633101 -1.165167258232458e-06 -0.058722903082402494 -0.4433 0.6299471306854634 0.6299451462160356 -1.1733757196152883e-06 -0.05873285494029437 -0.4434 0.6299668634077185 0.6299649007041839 -1.1813764813906058e-06 -0.05874280502249823 -0.4435 0.6299865919121226 0.6299846511261848 -1.189168060272694e-06 -0.05875275332903014 -0.44360000000000005 0.6300063162011028 0.6300043974804549 -1.1967490112230195e-06 -0.058762699859906356 -0.44370000000000004 0.6300260362770999 0.6300241397653968 -1.2041179273947211e-06 -0.058772644615143255 -0.44380000000000003 0.6300457521425683 0.6300438779793996 -1.2112734407432324e-06 -0.05878258759475741 -0.4439 0.6300654637999756 0.6300636121208399 -1.2182142221373038e-06 -0.05879252879876549 -0.444 0.6300851712518027 0.6300833421880816 -1.2249389816920697e-06 -0.05880246822718439 -0.44410000000000005 0.6301048745005429 0.6301030681794761 -1.2314464689078264e-06 -0.058812405880031164 -0.44420000000000004 0.6301245735487013 0.6301227900933635 -1.2377354730586099e-06 -0.058822341757322955 -0.44430000000000003 0.6301442683987954 0.6301425079280722 -1.243804823330974e-06 -0.05883227585907717 -0.4444 0.6301639590533533 0.6301622216819197 -1.2496533886852124e-06 -0.058842208185311246 -0.4445 0.6301836455149148 0.6301819313532129 -1.2552800788823149e-06 -0.05885213873604287 -0.4446 0.6302033277860298 0.6302016369402482 -1.2606838440121226e-06 -0.058862067511289855 -0.44470000000000004 0.6302230058692588 0.6302213384413125 -1.265863674965173e-06 -0.05887199451107017 -0.44480000000000003 0.6302426797671721 0.6302410358546826 -1.2708186037102553e-06 -0.05888191973540196 -0.4449 0.6302623494823492 0.6302607291786269 -1.2755477029613438e-06 -0.058891843184303516 -0.445 0.6302820150173787 0.6302804184114045 -1.2800500870935316e-06 -0.05890176485779324 -0.4451 0.6303016763748579 0.6303001035512668 -1.284324911948742e-06 -0.05891168475588979 -0.44520000000000004 0.6303213335573927 0.630319784596457 -1.2883713749745063e-06 -0.0589216028786119 -0.44530000000000003 0.6303409865675964 0.6303394615452108 -1.2921887153349854e-06 -0.058931519225978495 -0.4454 0.6303606354080897 0.6303591343957566 -1.2957762140497486e-06 -0.058941433798008626 -0.4455 0.630380280081501 0.6303788031463164 -1.2991331945488849e-06 -0.05895134659472156 -0.4456 0.6303999205904647 0.630398467795106 -1.3022590223399355e-06 -0.058961257616136666 -0.44570000000000004 0.6304195569376214 0.630418128340335 -1.305153105174428e-06 -0.05897116686227352 -0.44580000000000003 0.6304391891256185 0.6304377847802076 -1.3078148934364542e-06 -0.058981074333151785 -0.4459 0.6304588171571075 0.6304574371129228 -1.3102438800038918e-06 -0.058990980028791364 -0.446 0.6304784410347459 0.6304770853366751 -1.3124396004426941e-06 -0.05900088394921223 -0.4461 0.6304980607611954 0.6304967294496546 -1.3144016332011788e-06 -0.059010786094434546 -0.44620000000000004 0.630517676339122 0.6305163694500479 -1.3161295993324718e-06 -0.05902068646447867 -0.44630000000000003 0.6305372877711952 0.6305360053360377 -1.3176231629663526e-06 -0.059030585059365065 -0.4464 0.6305568950600886 0.6305556371058041 -1.3188820313647653e-06 -0.05904048187911437 -0.4465 0.6305764982084785 0.630575264757524 -1.319905954755285e-06 -0.059050376923747476 -0.4466 0.6305960972190432 0.6305948882893728 -1.3206947265254065e-06 -0.05906027019328524 -0.44670000000000004 0.6306156920944637 0.6306145076995235 -1.321248183111523e-06 -0.059070161687748826 -0.44680000000000003 0.6306352828374228 0.6306341229861483 -1.3215662042764809e-06 -0.059080051407159474 -0.4469 0.630654869450604 0.6306537341474177 -1.32164871310958e-06 -0.05908993935153859 -0.447 0.6306744519366922 0.6306733411815018 -1.3214956758322849e-06 -0.059099825520907735 -0.4471 0.6306940302983725 0.6306929440865716 -1.3211071019092469e-06 -0.0591097099152887 -0.44720000000000004 0.6307136045383306 0.630712542860797 -1.3204830442703486e-06 -0.059119592534703336 -0.44730000000000003 0.6307331746592514 0.6307321375023496 -1.3196235991164151e-06 -0.059129473379173736 -0.4474 0.6307527406638191 0.6307517280094013 -1.318528905530636e-06 -0.059139352448722086 -0.4475 0.6307723025547173 0.6307713143801263 -1.3171991463667432e-06 -0.05914922974337078 -0.4476 0.6307918603346268 0.6307908966127004 -1.3156345476106335e-06 -0.05915910526314229 -0.44770000000000004 0.6308114140062271 0.6308104747053013 -1.3138353783526124e-06 -0.059168979008059265 -0.44780000000000003 0.6308309635721956 0.6308300486561099 -1.3118019507041279e-06 -0.05917885097814457 -0.4479 0.6308505090352065 0.6308496184633106 -1.3095346201308367e-06 -0.05918872117342116 -0.448 0.6308700503979306 0.6308691841250909 -1.3070337852028047e-06 -0.05919858959391222 -0.4481 0.6308895876630354 0.6308887456396426 -1.304299887178173e-06 -0.05920845623964101 -0.44820000000000004 0.6309091208331841 0.6309083030051617 -1.3013334104194918e-06 -0.059218321110630995 -0.44830000000000003 0.6309286499110353 0.6309278562198489 -1.298134882199431e-06 -0.059228184206905746 -0.4484 0.6309481748992428 0.6309474052819108 -1.294704872534247e-06 -0.05923804552848905 -0.4485 0.6309676958004554 0.6309669501895592 -1.2910439938784712e-06 -0.05924790507540483 -0.4486 0.6309872126173159 0.6309864909410116 -1.2871529014024663e-06 -0.059257762847677135 -0.44870000000000004 0.631006725352461 0.6310060275344926 -1.2830322929369142e-06 -0.05926761884533021 -0.44880000000000003 0.6310262340085208 0.6310255599682335 -1.278682908112394e-06 -0.05927747306838841 -0.4489 0.6310457385881185 0.6310450882404729 -1.2741055291920489e-06 -0.0592873255168763 -0.449 0.6310652390938702 0.6310646123494568 -1.269300980349941e-06 -0.05929717619081857 -0.4491 0.631084735528384 0.6310841322934397 -1.2642701277265633e-06 -0.059307025090240065 -0.44920000000000004 0.6311042278942596 0.6311036480706841 -1.2590138789569938e-06 -0.05931687221516573 -0.44930000000000003 0.6311237161940888 0.631123159679462 -1.2535331836149854e-06 -0.05932671756562078 -0.4494 0.6311432004304539 0.6311426671180544 -1.24782903268561e-06 -0.05933656114163052 -0.4495 0.6311626806059281 0.631162170384752 -1.2419024580379023e-06 -0.059346402943220355 -0.4496 0.6311821567230748 0.6311816694778555 -1.2357545332020159e-06 -0.059356242970416 -0.44970000000000004 0.6312016287844471 0.6312011643956761 -1.2293863723422671e-06 -0.05936608122324313 -0.44980000000000003 0.6312210967925878 0.631220655136536 -1.2227991300906016e-06 -0.05937591770172771 -0.4499 0.6312405607500287 0.6312401416987687 -1.2159940017408832e-06 -0.05938575240589583 -0.45 0.6312600206592903 0.6312596240807193 -1.208972222999094e-06 -0.05939558533577374 -0.4501 0.6312794765228813 0.6312791022807451 -1.2017350694837337e-06 -0.05940541649138782 -0.45020000000000004 0.6312989283432986 0.6312985762972154 -1.1942838566425529e-06 -0.059415245872764616 -0.45030000000000003 0.6313183761230263 0.6313180461285125 -1.1866199396415311e-06 -0.059425073479930805 -0.4504 0.6313378198645356 0.6313375117730321 -1.178744712809765e-06 -0.059434899312913264 -0.4505 0.631357259570285 0.6313569732291834 -1.1706596097782462e-06 -0.059444723371738985 -0.4506 0.6313766952427188 0.6313764304953895 -1.1623661028414833e-06 -0.05945454565643518 -0.45070000000000005 0.6313961268842676 0.6313958835700876 -1.1538657029297461e-06 -0.05946436616702908 -0.45080000000000003 0.6314155544973474 0.63141533245173 -1.1451599594980433e-06 -0.05947418490354825 -0.4509 0.63143497808436 0.6314347771387838 -1.1362504598877443e-06 -0.05948400186602021 -0.451 0.6314543976476916 0.6314542176297313 -1.1271388290490236e-06 -0.05949381705447279 -0.4511 0.6314738131897133 0.6314736539230711 -1.1178267296241273e-06 -0.05950363046893388 -0.45120000000000005 0.6314932247127802 0.6314930860173177 -1.1083158612534838e-06 -0.05951344210943165 -0.45130000000000003 0.6315126322192315 0.631512513911002 -1.0986079605201926e-06 -0.059523251975994264 -0.4514 0.6315320357113894 0.6315319376026721 -1.0887048005614464e-06 -0.05953306006865014 -0.4515 0.6315514351915597 0.6315513570908928 -1.078608190596686e-06 -0.05954286638742783 -0.4516 0.6315708306620307 0.631570772374247 -1.0683199758720896e-06 -0.059552670932356014 -0.45170000000000005 0.6315902221250733 0.6315901834513349 -1.0578420372719943e-06 -0.05956247370346355 -0.45180000000000003 0.6316096095829403 0.6316095903207753 -1.0471762905972515e-06 -0.059572274700779415 -0.4519 0.6316289930378666 0.631628992981206 -1.036324686926049e-06 -0.059582073924332825 -0.452 0.6316483724920681 0.6316483914312828 -1.0252892116147105e-06 -0.05959187137415304 -0.4521 0.631667747947742 0.6316677856696814 -1.0140718841311624e-06 -0.05960166705026957 -0.45220000000000005 0.6316871194070666 0.631687175695097 -1.002674758082689e-06 -0.059611460952712 -0.45230000000000004 0.6317064868722 0.6317065615062445 -9.910999199946868e-07 -0.059621253081510096 -0.4524 0.6317258503452807 0.6317259431018589 -9.793494898380217e-07 -0.05963104343669379 -0.4525 0.6317452098284272 0.6317453204806963 -9.674256201408493e-07 -0.05964083201829315 -0.4526 0.631764565323737 0.6317646936415332 -9.55330495627793e-07 -0.059650618826338424 -0.45270000000000005 0.631783916833287 0.6317840625831675 -9.430663329423883e-07 -0.05966040386085996 -0.45280000000000004 0.6318032643591334 0.6318034273044183 -9.30635380147482e-07 -0.0596701871218883 -0.4529 0.6318226079033106 0.6318227878041268 -9.18039916586455e-07 -0.05967996860945418 -0.453 0.6318419474678308 0.631842144081156 -9.052822519672876e-07 -0.059689748323588414 -0.4531 0.631861283054685 0.6318614961343915 -8.923647264458268e-07 -0.059699526264321984 -0.45320000000000005 0.6318806146658413 0.6318808439627412 -8.792897097931185e-07 -0.059709302431685984 -0.45330000000000004 0.6318999423032456 0.6319001875651364 -8.660596012843857e-07 -0.05971907682571181 -0.4534 0.6319192659688203 0.6319195269405316 -8.52676829199428e-07 -0.05972884944643084 -0.4535 0.6319385856644654 0.6319388620879043 -8.391438500454651e-07 -0.059738620293874695 -0.4536 0.6319579013920568 0.6319581930062561 -8.254631486126485e-07 -0.05974838936807512 -0.45370000000000005 0.6319772131534469 0.6319775196946129 -8.116372372246605e-07 -0.05975815666906403 -0.45380000000000004 0.6319965209504643 0.6319968421520246 -7.976686552668699e-07 -0.059767922196873484 -0.4539 0.6320158247849132 0.6320161603775656 -7.835599688532646e-07 -0.05977768595153567 -0.454 0.6320351246585735 0.6320354743703355 -7.693137702713404e-07 -0.059787447933082986 -0.4541 0.6320544205731999 0.6320547841294586 -7.549326775657672e-07 -0.0597972081415479 -0.45420000000000005 0.6320737125305226 0.6320740896540848 -7.404193339555221e-07 -0.05980696657696314 -0.45430000000000004 0.6320930005322459 0.6320933909433898 -7.257764075840889e-07 -0.05981672323936147 -0.4544 0.6321122845800495 0.6321126879965745 -7.110065906312801e-07 -0.05982647812877589 -0.4545 0.6321315646755867 0.6321319808128663 -6.961125992854811e-07 -0.05983623124523951 -0.4546 0.632150840820485 0.6321512693915186 -6.810971728554716e-07 -0.059845982588785575 -0.45470000000000005 0.6321701130163458 0.6321705537318114 -6.659630735483812e-07 -0.05985573215944753 -0.45480000000000004 0.6321893812647443 0.6321898338330515 -6.507130857758003e-07 -0.05986547995725893 -0.4549 0.6322086455672288 0.6322091096945728 -6.35350015792957e-07 -0.05987522598225353 -0.455 0.6322279059253209 0.6322283813157359 -6.198766910325837e-07 -0.05988497023446522 -0.4551 0.6322471623405153 0.6322476486959293 -6.042959596885833e-07 -0.059894712713928 -0.45520000000000005 0.6322664148142791 0.6322669118345685 -5.886106901609178e-07 -0.05990445342067603 -0.45530000000000004 0.6322856633480521 0.632286170731097 -5.728237705698858e-07 -0.059914192354743684 -0.4554 0.6323049079432472 0.6323054253849865 -5.569381081177438e-07 -0.05992392951616543 -0.4555 0.6323241486012484 0.6323246757957365 -5.409566287833956e-07 -0.059933664904975904 -0.4556 0.6323433853234124 0.6323439219628745 -5.248822764342131e-07 -0.05994339852120985 -0.45570000000000005 0.6323626181110679 0.6323631638859573 -5.087180126317481e-07 -0.05995313036490229 -0.45580000000000004 0.6323818469655147 0.6323824015645697 -4.924668158129419e-07 -0.05996286043608823 -0.4559 0.6324010718880244 0.6324016349983255 -4.761316810125704e-07 -0.05997258873480293 -0.456 0.6324202928798404 0.6324208641868673 -4.597156190583318e-07 -0.059982315261081776 -0.4561 0.6324395099421765 0.6324400891298672 -4.432216562100244e-07 -0.05999204001496035 -0.45620000000000005 0.6324587230762182 0.6324593098270264 -4.266528334379016e-07 -0.0600017629964743 -0.45630000000000004 0.6324779322831215 0.6324785262780751 -4.100122059508271e-07 -0.060011484205659466 -0.45640000000000003 0.6324971375640136 0.6324977384827737 -3.933028426966745e-07 -0.06002120364255184 -0.4565 0.6325163389199919 0.6325169464409119 -3.765278256753768e-07 -0.06003092130718756 -0.4566 0.6325355363521243 0.6325361501523094 -3.5969024945320394e-07 -0.060040637199602925 -0.45670000000000005 0.6325547298614498 0.6325553496168155 -3.4279322051050665e-07 -0.06005035131983434 -0.4568 0.632573919448977 0.6325745448343099 -3.258398567976273e-07 -0.060060063667918474 -0.45690000000000003 0.6325931051156851 0.6325937358047022 -3.088332870548882e-07 -0.06006977424389201 -0.457 0.6326122868625229 0.6326129225279329 -2.9177665025054145e-07 -0.06007948304779187 -0.4571 0.6326314646904097 0.6326321050039715 -2.7467309502565707e-07 -0.06008919007965507 -0.45720000000000005 0.6326506386002341 0.632651283232819 -2.5752577913901176e-07 -0.0600988953395188 -0.4573 0.632669808592855 0.6326704572145072 -2.403378687731994e-07 -0.06010859882742045 -0.45740000000000003 0.6326889746691008 0.6326896269490974 -2.2311253810441967e-07 -0.060118300543397424 -0.4575 0.6327081368297696 0.6327087924366828 -2.0585296862246638e-07 -0.06012800048748743 -0.4576 0.632727295075629 0.6327279536773862 -1.8856234851663545e-07 -0.06013769865972828 -0.45770000000000005 0.632746449407416 0.6327471106713624 -1.7124387221081894e-07 -0.06014739506015785 -0.4578 0.6327655998258369 0.632766263418796 -1.5390073963492124e-07 -0.06015708968881427 -0.45790000000000003 0.6327847463315681 0.6327854119199037 -1.365361556975031e-07 -0.06016678254573579 -0.458 0.6328038889252543 0.6328045561749319 -1.1915332972026182e-07 -0.060176473630960736 -0.4581 0.6328230276075105 0.632823696184159 -1.0175547477189739e-07 -0.06018616294452772 -0.45820000000000005 0.6328421623789204 0.6328428319478943 -8.434580714943019e-08 -0.06019585048647541 -0.4583 0.6328612932400366 0.6328619634664778 -6.692754573461857e-08 -0.06020553625684264 -0.45840000000000003 0.6328804201913818 0.6328810907402809 -4.950391141109178e-08 -0.06021522025566837 -0.4585 0.632899543233447 0.6329002137697064 -3.207812647606188e-08 -0.060224902482991796 -0.4586 0.6329186623666931 0.6329193325551881 -1.4653414035555729e-08 -0.06023458293885217 -0.45870000000000005 0.6329377775915493 0.6329384470971905 2.7670025888604233e-09 -0.060244261623288914 -0.4588 0.6329568889084147 0.6329575573962101 2.0179900460728928e-08 -0.06025393853634164 -0.45890000000000003 0.6329759963176573 0.6329766634527737 3.7582057618723574e-08 -0.06026361367805007 -0.459 0.6329950998196141 0.6329957652674401 5.497025368401964e-08 -0.06027328704845406 -0.4591 0.6330141994145915 0.6330148628407988 7.23412704566051e-08 -0.06028295864759371 -0.45920000000000005 0.6330332951028652 0.6330339561734701 8.969189247906573e-08 -0.06029262847550915 -0.4593 0.6330523868846794 0.6330530452661061 1.0701890769404532e-07 -0.06030229653224069 -0.45940000000000003 0.6330714747602483 0.6330721301193896 1.2431910799068357e-07 -0.06031196281782883 -0.4595 0.6330905587297553 0.6330912107340343 1.4158928979615681e-07 -0.0603216273323142 -0.4596 0.6331096387933528 0.6331102871107853 1.5882625472446454e-07 -0.060331290075737565 -0.45970000000000005 0.6331287149511631 0.6331293592504184 1.7602681012807153e-07 -0.06034095104813986 -0.4598 0.6331477872032776 0.6331484271537401 1.9318776967036655e-07 -0.06035061024956219 -0.45990000000000003 0.6331668555497568 0.6331674908215881 2.1030595396404062e-07 -0.06036026768004571 -0.46 0.6331859199906317 0.6331865502548304 2.2737819115048463e-07 -0.06036992333963181 -0.4601 0.6332049805259022 0.6332056054543662 2.444013174549009e-07 -0.060379577228362014 -0.46020000000000005 0.633224037155538 0.6332246564211247 2.6137217783162026e-07 -0.06038922934627795 -0.4603 0.6332430898794786 0.6332437031560665 2.782876264983969e-07 -0.06039887969342148 -0.46040000000000003 0.6332621386976338 0.6332627456601818 2.951445275747866e-07 -0.06040852826983454 -0.4605 0.6332811836098833 0.6332817839344915 3.1193975556093045e-07 -0.06041817507555927 -0.4606 0.6333002246160764 0.6333008179800468 3.286701960314442e-07 -0.06042782011063791 -0.46070000000000005 0.6333192617160327 0.6333198477979287 3.4533274623216315e-07 -0.06043746337511285 -0.4608 0.6333382949095427 0.6333388733892487 3.6192431548953685e-07 -0.06044710486902665 -0.46090000000000003 0.6333573241963667 0.6333578947551476 3.7844182591839637e-07 -0.06045674459242201 -0.461 0.6333763495762355 0.6333769118967968 3.948822130950269e-07 -0.060466382545341806 -0.4611 0.6333953710488509 0.6333959248153964 4.112424263902348e-07 -0.06047601872782896 -0.46120000000000005 0.6334143886138855 0.633414933512177 4.275194296077256e-07 -0.06048565313992671 -0.4613 0.6334334022709827 0.6334339379883975 4.4371020171962705e-07 -0.06049528578167828 -0.46140000000000003 0.6334524120197567 0.6334529382453472 4.598117372273114e-07 -0.06050491665312712 -0.4615 0.6334714178597934 0.6334719342843437 4.758210468552848e-07 -0.06051454575431686 -0.4616 0.6334904197906501 0.6334909261067335 4.9173515803691e-07 -0.06052417308529118 -0.46170000000000005 0.6335094178118553 0.6335099137138924 5.075511154001289e-07 -0.06053379864609398 -0.4618 0.6335284119229093 0.6335288971072244 5.232659815584961e-07 -0.06054342243676928 -0.46190000000000003 0.6335474021232843 0.633547876288162 5.388768373609798e-07 -0.060553044457361274 -0.462 0.633566388412425 0.6335668512581661 5.543807827246283e-07 -0.060562664707914264 -0.4621 0.6335853707897473 0.6335858220187256 5.697749367872262e-07 -0.060572283188472714 -0.46220000000000006 0.6336043492546408 0.6336047885713572 5.850564389620061e-07 -0.06058189989908128 -0.4623 0.6336233238064667 0.6336237509176053 6.00222449159693e-07 -0.06059151483978468 -0.46240000000000003 0.6336422944445594 0.6336427090590419 6.15270148163205e-07 -0.060601128010627836 -0.4625 0.6336612611682269 0.6336616629972662 6.301967385574647e-07 -0.06061073941165584 -0.4626 0.6336802239767492 0.6336806127339046 6.44999444951444e-07 -0.06062034904291383 -0.46270000000000006 0.6336991828693809 0.6336995582706102 6.596755146442979e-07 -0.06062995690444722 -0.4628 0.6337181378453495 0.6337184996090631 6.742222180555757e-07 -0.060639562996301466 -0.46290000000000003 0.6337370889038565 0.6337374367509695 6.886368492664552e-07 -0.060649167318522226 -0.463 0.633756036044078 0.6337563696980615 7.029167266303649e-07 -0.060658769871155274 -0.4631 0.6337749792651641 0.633775298452098 7.170591930227843e-07 -0.06066837065424657 -0.46320000000000006 0.6337939185662395 0.6337942230148632 7.310616164379891e-07 -0.06067796966784222 -0.4633 0.6338128539464034 0.6338131433881665 7.449213908494734e-07 -0.06068756691198839 -0.46340000000000003 0.6338317854047307 0.6338320595738431 7.58635936043417e-07 -0.06069716238673151 -0.4635 0.6338507129402711 0.6338509715737528 7.722026986733965e-07 -0.06070675609211806 -0.4636 0.6338696365520502 0.6338698793897803 7.856191524546752e-07 -0.06071634802819473 -0.46370000000000006 0.633888556239069 0.6338887830238347 7.988827986638025e-07 -0.060725938195008315 -0.4638 0.6339074720003054 0.6339076824778493 8.11991166582704e-07 -0.06073552659260581 -0.46390000000000003 0.633926383834713 0.6339265777537816 8.249418140537923e-07 -0.06074511322103429 -0.464 0.633945291741222 0.6339454688536121 8.377323280073234e-07 -0.06075469808034101 -0.4641 0.6339641957187402 0.6339643557793455 8.503603247389524e-07 -0.060764281170573364 -0.46420000000000006 0.6339830957661519 0.6339832385330092 8.628234504926002e-07 -0.06077386249177892 -0.4643 0.6340019918823192 0.6340021171166532 8.751193817102543e-07 -0.060783442044005355 -0.46440000000000003 0.6340208840660819 0.6340209915323507 8.872458256703464e-07 -0.06079301982730049 -0.4645 0.6340397723162581 0.6340398617821961 8.992005208208198e-07 -0.060802595841712305 -0.4646 0.634058656631644 0.634058727868307 9.109812373342407e-07 -0.060812170087288966 -0.46470000000000006 0.6340775370110145 0.6340775897928215 9.225857772743318e-07 -0.06082174256407872 -0.4648 0.6340964134531237 0.6340964475578994 9.340119752898612e-07 -0.06083131327212994 -0.46490000000000004 0.6341152859567053 0.6341153011657217 9.452576988644434e-07 -0.06084088221149125 -0.465 0.6341341545204722 0.6341341506184897 9.5632084862185e-07 -0.06085044938221134 -0.4651 0.6341530191431171 0.6341529959184256 9.671993591031658e-07 -0.06086001478433907 -0.46520000000000006 0.6341718798233131 0.6341718370677709 9.778911987390337e-07 -0.06086957841792341 -0.4653 0.6341907365597141 0.6341906740687877 9.88394370404766e-07 -0.06087914028301353 -0.46540000000000004 0.634209589350955 0.6342095069237565 9.98706911808922e-07 -0.06088870037965868 -0.4655 0.6342284381956514 0.6342283356349779 1.0088268959096425e-06 -0.060898258707908354 -0.4656 0.6342472830924013 0.6342471602047702 1.0187524310811824e-06 -0.06090781526781208 -0.46570000000000006 0.634266124039784 0.6342659806354705 1.0284816617800452e-06 -0.0609173700594196 -0.4658 0.6342849610363613 0.6342847969294341 1.0380127684894713e-06 -0.060926923082780776 -0.46590000000000004 0.634303794080678 0.6343036090890336 1.0473439685243502e-06 -0.06093647433794561 -0.466 0.6343226231712614 0.634322417116659 1.0564735160589755e-06 -0.06094602382496428 -0.4661 0.6343414483066223 0.6343412210147175 1.065399702626646e-06 -0.06095557154388707 -0.46620000000000006 0.6343602694852553 0.6343600207856326 1.074120857175176e-06 -0.06096511749476441 -0.4663 0.6343790867056389 0.6343788164318441 1.0826353467330296e-06 -0.06097466167764692 -0.46640000000000004 0.6343978999662365 0.6343976079558078 1.0909415764648323e-06 -0.06098420409258533 -0.4665 0.6344167092654958 0.6344163953599948 1.0990379900877034e-06 -0.0609937447396305 -0.4666 0.6344355146018499 0.6344351786468918 1.1069230703153465e-06 -0.061003283618833504 -0.46670000000000006 0.6344543159737176 0.6344539578189993 1.1145953387192709e-06 -0.06101282073024547 -0.4668 0.6344731133795032 0.634472732878833 1.1220533563394142e-06 -0.061022356073917684 -0.46690000000000004 0.6344919068175977 0.6344915038289225 1.1292957240727208e-06 -0.06103188964990167 -0.467 0.6345106962863787 0.6345102706718104 1.1363210824510972e-06 -0.06104142145824898 -0.4671 0.6345294817842106 0.6345290334100533 1.1431281124740789e-06 -0.061050951499011345 -0.46720000000000006 0.6345482633094458 0.6345477920462204 1.149715535581075e-06 -0.06106047977224072 -0.4673 0.6345670408604243 0.6345665465828929 1.1560821136791244e-06 -0.061070006277989065 -0.46740000000000004 0.6345858144354741 0.6345852970226646 1.1622266499478062e-06 -0.06107953101630862 -0.4675 0.6346045840329124 0.6346040433681408 1.1681479884229073e-06 -0.061089053987251646 -0.4676 0.6346233496510449 0.6346227856219377 1.1738450148013335e-06 -0.061098575190870634 -0.46770000000000006 0.6346421112881672 0.6346415237866831 1.1793166560525314e-06 -0.061108094627218196 -0.4678 0.6346608689425641 0.6346602578650147 1.1845618812789116e-06 -0.061117612296347074 -0.46790000000000004 0.6346796226125113 0.6346789878595803 1.1895797013550258e-06 -0.06112712819831019 -0.468 0.6346983722962749 0.6346977137730374 1.1943691695937009e-06 -0.06113664233316052 -0.4681 0.6347171179921122 0.634716435608053 1.1989293815517499e-06 -0.061146154700951305 -0.46820000000000006 0.6347358596982715 0.6347351533673025 1.20325947541855e-06 -0.06115566530173586 -0.4683 0.6347545974129938 0.63475386705347 1.2073586319605312e-06 -0.061165174135567615 -0.46840000000000004 0.6347733311345112 0.6347725766692475 1.2112260750485326e-06 -0.061174681202500206 -0.4685 0.6347920608610496 0.6347912822173347 1.2148610714912689e-06 -0.06118418650258737 -0.4686 0.6348107865908278 0.6348099837004384 1.2182629311463522e-06 -0.061193690035883035 -0.46870000000000006 0.6348295083220579 0.6348286811212721 1.2214310074476487e-06 -0.061203191802441215 -0.4688 0.634848226052946 0.634847374482556 1.2243646971832334e-06 -0.06121269180231612 -0.46890000000000004 0.6348669397816924 0.6348660637870157 1.2270634407451908e-06 -0.06122219003556206 -0.469 0.6348856495064924 0.6348847490373826 1.2295267220185924e-06 -0.061231686502233464 -0.4691 0.6349043552255367 0.6349034302363933 1.2317540688533413e-06 -0.06124118120238499 -0.46920000000000006 0.6349230569370115 0.6349221073867888 1.2337450530086613e-06 -0.06125067413607143 -0.4693 0.6349417546390987 0.6349407804913144 1.2354992901808526e-06 -0.061260165303347616 -0.46940000000000004 0.6349604483299774 0.6349594495527193 1.2370164400310468e-06 -0.061269654704268595 -0.4695 0.634979138007823 0.6349781145737559 1.2382962064350078e-06 -0.06127914233888955 -0.4696 0.6349978236708085 0.6349967755571798 1.2393383373165978e-06 -0.06128862820726583 -0.46970000000000006 0.6350165053171046 0.6350154325057493 1.2401426251196224e-06 -0.061298112309452917 -0.4698 0.6350351829448799 0.6350340854222241 1.2407089062804744e-06 -0.061307594645506336 -0.46990000000000004 0.6350538565523025 0.6350527343093664 1.2410370616722233e-06 -0.061317075215481964 -0.47 0.6350725261375385 0.635071379169939 1.2411270164935928e-06 -0.06132655401943558 -0.4701 0.6350911916987542 0.6350900200067058 1.2409787403799832e-06 -0.06133603105742326 -0.47020000000000006 0.6351098532341154 0.6351086568224312 1.2405922473479603e-06 -0.06134550632950119 -0.4703 0.6351285107417884 0.6351272896198796 1.239967595795255e-06 -0.06135497983572569 -0.47040000000000004 0.6351471642199404 0.6351459184018143 1.2391048884452527e-06 -0.061364451576153216 -0.4705 0.6351658136667395 0.6351645431709987 1.2380042724580154e-06 -0.06137392155084037 -0.4706 0.6351844590803555 0.6351831639301939 1.2366659393747703e-06 -0.0613833897598439 -0.47070000000000006 0.6352031004589604 0.6352017806821604 1.2350901249513768e-06 -0.06139285620322073 -0.4708 0.6352217378007288 0.6352203934296554 1.2332771094358819e-06 -0.061402320881027886 -0.47090000000000004 0.6352403711038375 0.6352390021754339 1.231227217179942e-06 -0.06141178379332246 -0.471 0.6352590003664672 0.635257606922248 1.2289408168053573e-06 -0.06142124494016182 -0.4711 0.6352776255868023 0.6352762076728461 1.2264183207877366e-06 -0.061430704321603406 -0.47120000000000006 0.6352962467630316 0.635294804429973 1.223660186233655e-06 -0.06144016193770483 -0.4713 0.6353148638933479 0.6353133971963689 1.2206669136871628e-06 -0.06144961778852381 -0.47140000000000004 0.6353334769759497 0.6353319859747697 1.2174390478791874e-06 -0.06145907187411825 -0.4715 0.6353520860090403 0.6353505707679057 1.2139771773667096e-06 -0.06146852419454614 -0.4716 0.6353706909908294 0.6353691515785017 1.2102819342552085e-06 -0.061477974749865674 -0.47170000000000006 0.6353892919195328 0.6353877284092765 1.206353994337439e-06 -0.06148742354013514 -0.4718 0.6354078887933732 0.6354063012629427 1.202194076926899e-06 -0.061496870565413 -0.47190000000000004 0.6354264816105801 0.6354248701422056 1.1978029446080285e-06 -0.0615063158257578 -0.472 0.6354450703693907 0.6354434350497636 1.1931814032362098e-06 -0.06151575932122827 -0.4721 0.6354636550680504 0.6354619959883075 1.1883303016879676e-06 -0.061525201051883305 -0.47220000000000006 0.6354822357048127 0.6354805529605195 1.1832505318332132e-06 -0.06153464101778188 -0.4723 0.63550081227794 0.6354991059690737 1.1779430282021774e-06 -0.061544079218983166 -0.47240000000000004 0.6355193847857044 0.6355176550166353 1.1724087680409223e-06 -0.06155351565554649 -0.4725 0.6355379532263867 0.6355362001058598 1.1666487708394957e-06 -0.0615629503275312 -0.4726 0.6355565175982782 0.6355547412393932 1.160664098442954e-06 -0.06157238323499689 -0.47270000000000006 0.635575077899681 0.6355732784198715 1.1544558548015615e-06 -0.0615818143780033 -0.4728 0.6355936341289076 0.6355918116499195 1.1480251856099688e-06 -0.06159124375661025 -0.47290000000000004 0.635612186284282 0.6356103409321521 1.1413732782794561e-06 -0.06160067137087777 -0.473 0.6356307343641399 0.6356288662691715 1.134501361549356e-06 -0.06161009722086598 -0.4731 0.6356492783668286 0.6356473876635692 1.1274107053482751e-06 -0.06161952130663513 -0.47320000000000007 0.6356678182907087 0.635665905117924 1.1201026208496057e-06 -0.06162894362824568 -0.4733 0.6356863541341529 0.6356844186348021 1.1125784596666133e-06 -0.06163836418575811 -0.47340000000000004 0.6357048858955473 0.6357029282167572 1.1048396139634598e-06 -0.06164778297923316 -0.4735 0.6357234135732919 0.6357214338663291 1.0968875161221359e-06 -0.06165720000873164 -0.4736 0.6357419371658006 0.6357399355860442 1.0887236386591947e-06 -0.061666615274314565 -0.47370000000000007 0.635760456671502 0.6357584333784146 1.0803494935873736e-06 -0.061676028776043015 -0.4738 0.635778972088839 0.6357769272459382 1.0717666324988606e-06 -0.061685440513978264 -0.47390000000000004 0.63579748341627 0.6357954171910974 1.0629766460379386e-06 -0.0616948504881817 -0.474 0.6358159906522687 0.6358139032163598 1.0539811638454744e-06 -0.06170425869871482 -0.4741 0.6358344937953251 0.6358323853241771 1.04478185392054e-06 -0.06171366514563931 -0.47420000000000007 0.6358529928439455 0.635850863516985 1.0353804227314356e-06 -0.06172306982901701 -0.4743 0.6358714877966527 0.6358693377972032 1.025778614549555e-06 -0.06173247274890989 -0.47440000000000004 0.6358899786519862 0.6358878081672341 1.0159782112273419e-06 -0.06174187390537997 -0.4745 0.6359084654085038 0.6359062746294635 1.0059810319762441e-06 -0.06175127329848954 -0.4746 0.6359269480647802 0.635924737186259 9.95788932950381e-07 -0.061760670928300954 -0.47470000000000007 0.6359454266194089 0.6359431958399712 9.854038070522542e-07 -0.06177006679487673 -0.4748 0.6359639010710013 0.6359616505929315 9.748275832666131e-07 -0.06177946089827947 -0.47490000000000004 0.6359823714181881 0.635980101447454 9.64062226660456e-07 -0.06178885323857201 -0.475 0.6360008376596189 0.6359985484058325 9.531097377168951e-07 -0.06179824381581725 -0.4751 0.6360192997939631 0.6360169914703427 9.419721521963798e-07 -0.06180763263007826 -0.47520000000000007 0.6360377578199096 0.6360354306432403 9.306515405538285e-07 -0.06181701968141824 -0.4753 0.6360562117361679 0.6360538659267612 9.191500078831183e-07 -0.06182640496990058 -0.47540000000000004 0.6360746615414677 0.6360722973231208 9.074696930844173e-07 -0.06183578849558873 -0.4755 0.6360931072345598 0.6360907248345138 8.956127688919402e-07 -0.0618451702585463 -0.4756 0.6361115488142164 0.6361091484631146 8.835814412910814e-07 -0.061854550258837085 -0.47570000000000007 0.6361299862792302 0.6361275682110757 8.713779488800366e-07 -0.06186392849652494 -0.4758 0.6361484196284173 0.6361459840805287 8.590045630363363e-07 -0.06187330497167394 -0.47590000000000005 0.6361668488606144 0.6361643960735825 8.464635868343784e-07 -0.06188267968434822 -0.476 0.6361852739746816 0.6361828041923246 8.337573551842059e-07 -0.061892052634612116 -0.4761 0.6362036949695018 0.63620120843882 8.208882337767953e-07 -0.06190142382253011 -0.47620000000000007 0.6362221118439803 0.6362196088151104 8.078586194171233e-07 -0.061910793248166764 -0.4763 0.6362405245970463 0.6362380053232148 7.946709390249662e-07 -0.06192016091158684 -0.47640000000000005 0.6362589332276524 0.6362563979651288 7.813276493295884e-07 -0.061929526812855185 -0.4765 0.6362773377347752 0.636274786742824 7.67831236453409e-07 -0.0619388909520368 -0.4766 0.6362957381174159 0.6362931716582486 7.541842154124012e-07 -0.061948253329196845 -0.47670000000000007 0.6363141343745995 0.6363115527133261 7.403891296442477e-07 -0.06195761394440056 -0.4768 0.636332526505376 0.6363299299099556 7.264485505087404e-07 -0.06196697279771336 -0.47690000000000005 0.6363509145088211 0.6363483032500118 7.123650770379797e-07 -0.06197632988920091 -0.477 0.6363692983840349 0.6363666727353441 6.98141335103708e-07 -0.061985685218928804 -0.4771 0.6363876781301434 0.6363850383677765 6.837799771952646e-07 -0.0619950387869629 -0.47720000000000007 0.6364060537462991 0.6364034001491078 6.692836817950854e-07 -0.06200439059336924 -0.4773 0.6364244252316793 0.6364217580811106 6.546551528513467e-07 -0.06201374063821385 -0.47740000000000005 0.6364427925854889 0.6364401121655314 6.398971194726544e-07 -0.06202308892156301 -0.4775 0.6364611558069585 0.6364584624040911 6.250123352202763e-07 -0.062032435443483115 -0.4776 0.6364795148953457 0.6364768087984833 6.100035776640533e-07 -0.06204178020404068 -0.47770000000000007 0.6364978698499355 0.636495151350375 5.948736479105543e-07 -0.06205112320330234 -0.4778 0.63651622067004 0.6365134900614065 5.796253700479648e-07 -0.062060464441334943 -0.47790000000000005 0.6365345673549985 0.6365318249331906 5.64261590549342e-07 -0.06206980391820538 -0.478 0.6365529099041782 0.6365501559673128 5.487851778840369e-07 -0.06207914163398074 -0.4781 0.6365712483169745 0.6365684831653309 5.331990218654381e-07 -0.06208847758872824 -0.47820000000000007 0.6365895825928105 0.6365868065287749 5.17506033179127e-07 -0.0620978117825152 -0.4783 0.636607912731138 0.6366051260591468 5.017091428000109e-07 -0.06210714421540915 -0.47840000000000005 0.636626238731437 0.6366234417579202 4.858113014649668e-07 -0.06211647488747768 -0.4785 0.6366445605932165 0.6366417536265404 4.698154791316078e-07 -0.06212580379878856 -0.4786 0.6366628783160141 0.6366600616664239 4.5372466442317183e-07 -0.06213513094940967 -0.47870000000000007 0.636681191899397 0.6366783658789587 4.3754186410116525e-07 -0.06214445633940907 -0.4788 0.636699501342961 0.6366966662655034 4.212701024408627e-07 -0.062153779968854905 -0.47890000000000005 0.6367178066463317 0.6367149628273877 4.0491242063456223e-07 -0.06216310183781548 -0.479 0.6367361078091645 0.636733255565912 3.8847187631974034e-07 -0.06217242194635924 -0.4791 0.636754404831144 0.6367515444823474 3.719515430378184e-07 -0.0621817402945548 -0.47920000000000007 0.6367726977119853 0.6367698295779347 3.553545095819066e-07 -0.06219105688247082 -0.4793 0.6367909864514332 0.6367881108538858 3.386838793584257e-07 -0.06220037171017622 -0.47940000000000005 0.6368092710492629 0.6368063883113819 3.2194276992913995e-07 -0.062209684777739964 -0.4795 0.6368275515052793 0.6368246619515747 3.0513431244216793e-07 -0.06221899608523114 -0.4796 0.6368458278193189 0.6368429317755852 2.882616509103375e-07 -0.06222830563271904 -0.47970000000000007 0.6368640999912477 0.6368611977845045 2.7132794176015773e-07 -0.06223761342027304 -0.4798 0.6368823680209631 0.636879459979393 2.5433635313792946e-07 -0.06224691944796268 -0.47990000000000005 0.6369006319083931 0.6368977183612811 2.372900644170839e-07 -0.06225622371585765 -0.48 0.6369188916534967 0.6369159729311676 2.2019226550429316e-07 -0.062265526224027756 -0.4801 0.6369371472562637 0.6369342236900215 2.0304615631905332e-07 -0.06227482697254292 -0.48020000000000007 0.6369553987167152 0.6369524706387801 1.8585494614836717e-07 -0.06228412596147323 -0.4803 0.6369736460349037 0.6369707137783507 1.686218530985717e-07 -0.0622934231908889 -0.48040000000000005 0.6369918892109125 0.6369889531096086 1.513501034083875e-07 -0.06230271866086026 -0.4805 0.6370101282448571 0.6370071886333987 1.3404293094237962e-07 -0.06231201237145783 -0.4806 0.6370283631368836 0.637025420350534 1.1670357652482366e-07 -0.062321304322752215 -0.48070000000000007 0.6370465938871702 0.6370436482617969 9.933528734296093e-08 -0.062330594514814146 -0.4808 0.6370648204959263 0.6370618723679387 8.194131635025359e-08 -0.062339882947714545 -0.48090000000000005 0.6370830429633932 0.637080092669678 6.452492163841472e-08 -0.06234916962152444 -0.481 0.637101261289844 0.6370983091677036 4.708936585107182e-08 -0.06235845453631499 -0.4811 0.6371194754755833 0.6371165218626719 2.9637915569674655e-08 -0.06236773769215749 -0.48120000000000007 0.6371376855209475 0.6371347307552078 1.2173840666443447e-08 -0.06237701908912339 -0.4813 0.6371558914263049 0.637152935845905 -5.299586266355183e-09 -0.06238629872728423 -0.48140000000000005 0.6371740931920555 0.6371711371353257 -2.277909054958227e-08 -0.06239557660671174 -0.4815 0.6371922908186312 0.637189334624 -4.0261396029150215e-08 -0.06240485272747775 -0.48160000000000003 0.637210484306496 0.6372075283124269 -5.7743225692716976e-08 -0.062414127089654214 -0.4817000000000001 0.6372286736561456 0.6372257182010735 -7.522130227987506e-08 -0.062423399693313286 -0.4818 0.6372468588681074 0.6372439042903756 -9.269234889971306e-08 -0.062432670538527205 -0.48190000000000005 0.637265039942941 0.637262086580737 -1.1015308965314774e-07 -0.06244193962536833 -0.482 0.6372832168812377 0.6372802650725302 -1.2760025022706678e-07 -0.06245120695390917 -0.48210000000000003 0.6373013896836206 0.6372984397660961 -1.4503055853661018e-07 -0.062460472524222405 -0.4822000000000001 0.6373195583507446 0.6373166106617438 -1.6244074531324149e-07 -0.062469736336380755 -0.4823 0.6373377228832966 0.6373347777597512 -1.7982754474399343e-07 -0.06247899839045722 -0.48240000000000005 0.637355883281995 0.6373529410603644 -1.9718769506474332e-07 -0.062488258686524814 -0.4825 0.6373740395475905 0.6373711005637983 -2.1451793919338713e-07 -0.06249751722465674 -0.48260000000000003 0.6373921916808647 0.6373892562702362 -2.3181502531097187e-07 -0.06250677400492631 -0.4827 0.6374103396826314 0.6374074081798303 -2.4907570751742103e-07 -0.06251602902740698 -0.4828 0.6374284835537358 0.6374255562927009 -2.662967463831767e-07 -0.06252528229217234 -0.48290000000000005 0.6374466232950544 0.6374437006089377 -2.8347490964308886e-07 -0.06253453379929612 -0.483 0.6374647589074951 0.6374618411285989 -3.0060697271683257e-07 -0.06254378354885211 -0.48310000000000003 0.6374828903919978 0.6374799778517117 -3.176897193507555e-07 -0.0625530315409144 -0.4832 0.6375010177495332 0.6374981107782725 -3.3471994224931745e-07 -0.0625622777755571 -0.4833 0.6375191409811032 0.6375162399082461 -3.5169444362326274e-07 -0.06257152225285444 -0.48340000000000005 0.637537260087741 0.6375343652415675 -3.686100358904487e-07 -0.06258076497288086 -0.4835 0.6375553750705107 0.6375524867781398 -3.8546354211993483e-07 -0.06259000593571086 -0.48360000000000003 0.6375734859305072 0.6375706045178363 -4.022517968021999e-07 -0.06259924514141908 -0.4837 0.637591592668856 0.6375887184604994 -4.1897164632098693e-07 -0.06260848259008032 -0.4838 0.6376096952867141 0.6376068286059408 -4.3561994959862016e-07 -0.06261771828176954 -0.48390000000000005 0.6376277937852682 0.6376249349539428 -4.5219357869275e-07 -0.0626269522165618 -0.484 0.637645888165736 0.6376430375042569 -4.6868941937228126e-07 -0.0626361843945323 -0.48410000000000003 0.6376639784293651 0.6376611362566048 -4.851043716308512e-07 -0.06264541481575636 -0.4842 0.6376820645774333 0.637679231210678 -5.014353504917413e-07 -0.06265464348030944 -0.4843 0.6377001466112489 0.6376973223661386 -5.176792863131885e-07 -0.06266387038826715 -0.48440000000000005 0.6377182245321492 0.6377154097226191 -5.338331255932971e-07 -0.06267309553970526 -0.4845 0.6377362983415021 0.6377334932797223 -5.498938314418833e-07 -0.0626823189346996 -0.48460000000000003 0.6377543680407043 0.6377515730370217 -5.658583840800757e-07 -0.06269154057332614 -0.4847 0.6377724336311823 0.637769648994062 -5.817237816035936e-07 -0.06270076045566103 -0.4848 0.6377904951143918 0.6377877211503588 -5.974870403990806e-07 -0.06270997858178055 -0.48490000000000005 0.6378085524918176 0.6378057895053989 -6.131451957408496e-07 -0.06271919495176112 -0.485 0.6378266057649727 0.6378238540586403 -6.286953023598718e-07 -0.06272840956567918 -0.48510000000000003 0.6378446549353998 0.6378419148095134 -6.44134435040522e-07 -0.06273762242361151 -0.4852 0.6378627000046692 0.6378599717574195 -6.594596891201787e-07 -0.06274683352563484 -0.4853 0.6378807409743797 0.6378780249017322 -6.746681810720911e-07 -0.06275604287182611 -0.48540000000000005 0.6378987778461584 0.6378960742417972 -6.897570490049798e-07 -0.06276525046226236 -0.4855 0.63791681062166 0.6379141197769331 -7.047234532042701e-07 -0.0627744562970208 -0.48560000000000003 0.6379348393025667 0.6379321615064311 -7.19564576742715e-07 -0.06278366037617876 -0.4857 0.6379528638905886 0.6379501994295543 -7.342776259661177e-07 -0.06279286269981374 -0.4858 0.6379708843874626 0.63796823354554 -7.488598310068095e-07 -0.06280206326800325 -0.48590000000000005 0.6379889007949529 0.6379862638535986 -7.633084463387618e-07 -0.06281126208082513 -0.486 0.6380069131148496 0.6380042903529132 -7.77620751277186e-07 -0.06282045913835711 -0.48610000000000003 0.6380249213489703 0.6380223130426415 -7.917940505752785e-07 -0.06282965444067727 -0.4862 0.638042925499158 0.6380403319219152 -8.058256747711656e-07 -0.06283884798786367 -0.4863 0.6380609255672822 0.63805834698984 -8.197129808817927e-07 -0.06284803977999463 -0.48640000000000005 0.6380789215552383 0.6380763582454964 -8.334533526666021e-07 -0.0628572298171485 -0.4865 0.6380969134649461 0.6380943656879391 -8.470442014463231e-07 -0.06286641809940376 -0.48660000000000003 0.6381149012983518 0.6381123693161986 -8.604829662972602e-07 -0.0628756046268391 -0.4867 0.6381328850574259 0.6381303691292806 -8.737671146064052e-07 -0.06288478939953329 -0.4868 0.6381508647441638 0.6381483651261659 -8.868941427375709e-07 -0.06289397241756524 -0.48690000000000005 0.6381688403605852 0.6381663573058121 -8.998615762534357e-07 -0.06290315368101405 -0.487 0.6381868119087335 0.6381843456671518 -9.126669706371882e-07 -0.0629123331899588 -0.48710000000000003 0.6382047793906768 0.6382023302090951 -9.253079115145724e-07 -0.0629215109444789 -0.4872 0.6382227428085054 0.6382203109305286 -9.3778201526451e-07 -0.06293068694465373 -0.4873 0.6382407021643343 0.6382382878303154 -9.500869293244119e-07 -0.06293986119056288 -0.48740000000000006 0.6382586574602999 0.6382562609072965 -9.622203330228452e-07 -0.06294903368228602 -0.4875 0.6382766086985624 0.6382742301602905 -9.741799374962667e-07 -0.062958204419903 -0.48760000000000003 0.6382945558813036 0.6382921955880939 -9.859634863829125e-07 -0.06296737340349383 -0.4877 0.6383124990107276 0.6383101571894817 -9.975687562668867e-07 -0.0629765406331386 -0.4878 0.63833043808906 0.638328114963207 -1.0089935571500064e-06 -0.06298570610891745 -0.48790000000000006 0.6383483731185478 0.6383460689080025 -1.0202357327848688e-06 -0.06299486983091084 -0.488 0.6383663041014587 0.6383640190225792 -1.0312931608968956e-06 -0.06300403179919921 -0.48810000000000003 0.6383842310400816 0.6383819653056291 -1.0421637540725115e-06 -0.06301319201386323 -0.4882 0.6384021539367248 0.6383999077558227 -1.0528454597868997e-06 -0.06302235047498354 -0.4883 0.6384200727937179 0.6384178463718116 -1.0633362608203356e-06 -0.06303150718264114 -0.48840000000000006 0.6384379876134092 0.6384357811522284 -1.0736341757300316e-06 -0.06304066213691703 -0.4885 0.6384558983981665 0.6384537120956852 -1.083737259044426e-06 -0.06304981533789229 -0.48860000000000003 0.6384738051503768 0.6384716392007771 -1.0936436021791174e-06 -0.06305896678564826 -0.4887 0.6384917078724452 0.6384895624660796 -1.1033513330760414e-06 -0.06306811648026636 -0.4888 0.6385096065667956 0.6385074818901509 -1.1128586170083832e-06 -0.0630772644218281 -0.48890000000000006 0.6385275012358691 0.638525397471531 -1.1221636570246663e-06 -0.06308641061041508 -0.489 0.6385453918821251 0.6385433092087434 -1.1312646938099746e-06 -0.06309555504610921 -0.48910000000000003 0.6385632785080396 0.6385612171002942 -1.1401600063243311e-06 -0.06310469772899234 -0.4892 0.6385811611161054 0.6385791211446731 -1.1488479122467865e-06 -0.06311383865914658 -0.4893 0.6385990397088317 0.6385970213403539 -1.1573267680864419e-06 -0.06312297783665409 -0.48940000000000006 0.6386169142887442 0.6386149176857943 -1.1655949697098045e-06 -0.06313211526159723 -0.4895 0.6386347848583833 0.6386328101794365 -1.1736509524795657e-06 -0.06314125093405835 -0.48960000000000004 0.6386526514203055 0.6386506988197082 -1.1814931914766458e-06 -0.0631503848541201 -0.4897 0.6386705139770819 0.6386685836050224 -1.1891202019720382e-06 -0.06315951702186523 -0.4898 0.6386883725312976 0.6386864645337775 -1.1965305396766102e-06 -0.06316864743737652 -0.48990000000000006 0.6387062270855527 0.6387043416043587 -1.2037228009631473e-06 -0.06317777610073698 -0.49 0.6387240776424603 0.6387222148151375 -1.2106956233104427e-06 -0.06318690301202973 -0.49010000000000004 0.6387419242046468 0.6387400841644713 -1.2174476853310523e-06 -0.06319602817133793 -0.4902 0.6387597667747518 0.6387579496507065 -1.223977706854562e-06 -0.06320515157874494 -0.4903 0.638777605355427 0.6387758112721766 -1.2302844498712773e-06 -0.0632142732343343 -0.49040000000000006 0.6387954399493367 0.6387936690272034 -1.2363667181436444e-06 -0.06322339313818963 -0.4905 0.6388132705591563 0.6388115229140968 -1.242223357622585e-06 -0.06323251129039463 -0.49060000000000004 0.6388310971875726 0.638829372931156 -1.2478532568083178e-06 -0.06324162769103318 -0.4907 0.6388489198372836 0.6388472190766703 -1.2532553467226037e-06 -0.06325074234018935 -0.4908 0.6388667385109976 0.6388650613489175 -1.2584286011585455e-06 -0.06325985523794724 -0.49090000000000006 0.6388845532114327 0.6388828997461669 -1.2633720371524326e-06 -0.06326896638439113 -0.491 0.6389023639413165 0.6389007342666775 -1.268084714955986e-06 -0.06327807577960537 -0.49110000000000004 0.6389201707033861 0.6389185649086997 -1.2725657381196243e-06 -0.06328718342367454 -0.4912 0.6389379735003874 0.6389363916704758 -1.2768142539087979e-06 -0.06329628931668327 -0.4913 0.6389557723350741 0.6389542145502394 -1.2808294533317444e-06 -0.06330539345871633 -0.49140000000000006 0.6389735672102084 0.6389720335462168 -1.2846105713337774e-06 -0.06331449584985864 -0.4915 0.6389913581285597 0.6389898486566269 -1.2881568869360649e-06 -0.06332359649019526 -0.49160000000000004 0.6390091450929042 0.6390076598796821 -1.291467723346651e-06 -0.06333269537981132 -0.4917 0.6390269281060255 0.639025467213588 -1.2945424481825007e-06 -0.06334179251879211 -0.4918 0.6390447071707126 0.6390432706565445 -1.2973804734139893e-06 -0.06335088790722314 -0.49190000000000006 0.6390624822897607 0.6390610702067463 -1.299981255725724e-06 -0.06335998154518994 -0.492 0.6390802534659702 0.6390788658623825 -1.302344296599811e-06 -0.06336907343277819 -0.49210000000000004 0.639098020702146 0.6390966576216375 -1.3044691422048338e-06 -0.06337816357007359 -0.4922 0.6391157840010984 0.6391144454826921 -1.306355383590141e-06 -0.06338725195716223 -0.4923 0.6391335433656404 0.6391322294437229 -1.3080026567691139e-06 -0.06339633859413012 -0.49240000000000006 0.6391512987985899 0.6391500095029033 -1.3094106429689667e-06 -0.06340542348106346 -0.4925 0.6391690503027669 0.6391677856584037 -1.3105790684919683e-06 -0.06341450661804857 -0.49260000000000004 0.6391867978809949 0.639185557908392 -1.3115077046876866e-06 -0.0634235880051719 -0.4927 0.6392045415360992 0.6392033262510346 -1.312196368286056e-06 -0.06343266764252008 -0.4928 0.639222281270907 0.6392210906844956 -1.3126449212308433e-06 -0.06344174553017977 -0.49290000000000006 0.6392400170882466 0.6392388512069385 -1.3128532709294483e-06 -0.06345082166823783 -0.493 0.6392577489909481 0.6392566078165257 -1.3128213698643254e-06 -0.06345989605678123 -0.49310000000000004 0.6392754769818414 0.6392743605114197 -1.3125492159815622e-06 -0.06346896869589709 -0.4932 0.6392932010637564 0.639292109289783 -1.312036852552101e-06 -0.06347803958567257 -0.4933 0.6393109212395228 0.6393098541497787 -1.3112843683937836e-06 -0.06348710872619505 -0.49340000000000006 0.6393286375119698 0.6393275950895712 -1.310291897399507e-06 -0.06349617611755203 -0.4935 0.6393463498839247 0.6393453321073258 -1.3090596189535564e-06 -0.06350524175983108 -0.49360000000000004 0.6393640583582136 0.6393630652012108 -1.3075877575985384e-06 -0.06351430565311997 -0.4937 0.6393817629376604 0.6393807943693959 -1.3058765833962038e-06 -0.06352336779750653 -0.4938 0.6393994636250862 0.639398519610054 -1.3039264113445803e-06 -0.06353242819307879 -0.49390000000000006 0.639417160423309 0.6394162409213615 -1.3017376017665505e-06 -0.06354148683992482 -0.494 0.6394348533351439 0.6394339583014983 -1.2993105600045407e-06 -0.06355054373813292 -0.49410000000000004 0.6394525423634017 0.639451671748648 -1.2966457366148099e-06 -0.06355959888779142 -0.49420000000000003 0.6394702275108886 0.6394693812609997 -1.2937436268123381e-06 -0.06356865228898882 -0.4943 0.6394879087804061 0.6394870868367468 -1.2906047708038937e-06 -0.06357770394181375 -0.49440000000000006 0.6395055861747512 0.6395047884740885 -1.2872297536214994e-06 -0.06358675384635495 -0.4945 0.6395232596967144 0.6395224861712296 -1.2836192051501882e-06 -0.0635958020027013 -0.49460000000000004 0.6395409293490807 0.6395401799263816 -1.2797737994618696e-06 -0.06360484841094183 -0.49470000000000003 0.6395585951346283 0.6395578697377625 -1.275694255231663e-06 -0.0636138930711657 -0.4948 0.6395762570561283 0.6395755556035975 -1.2713813354325865e-06 -0.0636229359834621 -0.4949 0.6395939151163447 0.6395932375221197 -1.2668358471967789e-06 -0.06363197714792045 -0.495 0.6396115693180336 0.6396109154915698 -1.262058641621211e-06 -0.0636410165646303 -0.49510000000000004 0.6396292196639429 0.6396285895101972 -1.2570506138509518e-06 -0.0636500542336812 -0.49520000000000003 0.6396468661568118 0.6396462595762604 -1.2518127025795689e-06 -0.06365909015516301 -0.4953 0.6396645087993704 0.639663925688027 -1.2463458899936164e-06 -0.06366812432916556 -0.4954 0.6396821475943394 0.6396815878437745 -1.2406512016338578e-06 -0.06367715675577894 -0.4955 0.6396997825444293 0.6396992460417903 -1.2347297064507767e-06 -0.06368618743509326 -0.49560000000000004 0.6397174136523405 0.6397169002803726 -1.2285825160829322e-06 -0.0636952163671988 -0.49570000000000003 0.6397350409207625 0.6397345505578307 -1.2222107850790032e-06 -0.06370424355218594 -0.4958 0.6397526643523734 0.6397521968724852 -1.215615710453699e-06 -0.0637132689901452 -0.4959 0.6397702839498405 0.6397698392226683 -1.2087985316044936e-06 -0.06372229268116725 -0.496 0.6397878997158184 0.6397874776067252 -1.2017605299785572e-06 -0.0637313146253429 -0.49610000000000004 0.6398055116529491 0.6398051120230127 -1.1945030290727576e-06 -0.063740334822763 -0.49620000000000003 0.6398231197638622 0.6398227424699017 -1.1870273937397702e-06 -0.0637493532735186 -0.4963 0.6398407240511741 0.639840368945776 -1.1793350302713446e-06 -0.06375836997770089 -0.4964 0.6398583245174871 0.6398579914490333 -1.1714273862872826e-06 -0.0637673849354011 -0.4965 0.63987592116539 0.6398756099780856 -1.163305949902771e-06 -0.06377639814671061 -0.49660000000000004 0.6398935139974571 0.63989322453136 -1.1549722500059367e-06 -0.06378540961172106 -0.49670000000000003 0.6399111030162472 0.639910835107298 -1.1464278558415142e-06 -0.06379441933052403 -0.4968 0.6399286882243049 0.6399284417043569 -1.1376743764279773e-06 -0.06380342730321131 -0.4969 0.6399462696241586 0.6399460443210099 -1.1287134605852955e-06 -0.06381243352987485 -0.497 0.6399638472183204 0.6399636429557464 -1.119546796657378e-06 -0.06382143801060668 -0.49710000000000004 0.6399814210092869 0.6399812376070724 -1.110176111762673e-06 -0.06383044074549896 -0.49720000000000003 0.6399989909995372 0.6399988282735107 -1.1006031719329457e-06 -0.06383944173464394 -0.4973 0.6400165571915333 0.6400164149536018 -1.0908297817247004e-06 -0.06384844097813407 -0.4974 0.64003411958772 0.6400339976459037 -1.0808577835530464e-06 -0.06385743847606183 -0.4975 0.6400516781905244 0.6400515763489928 -1.0706890576916983e-06 -0.06386643422852 -0.49760000000000004 0.640069233002355 0.6400691510614636 -1.060325521801131e-06 -0.06387542823560126 -0.49770000000000003 0.6400867840256016 0.6400867217819297 -1.0497691305122459e-06 -0.06388442049739858 -0.4978 0.6401043312626352 0.6401042885090238 -1.0390218752320823e-06 -0.06389341101400497 -0.4979 0.6401218747158076 0.6401218512413982 -1.0280857836719726e-06 -0.06390239978551362 -0.498 0.6401394143874507 0.6401394099777254 -1.0169629193479413e-06 -0.06391138681201781 -0.49810000000000004 0.6401569502798763 0.6401569647166977 -1.0056553812476388e-06 -0.06392037209361094 -0.49820000000000003 0.640174482395376 0.6401745154570282 -9.9416530377483e-07 -0.06392935563038653 -0.4983 0.6401920107362206 0.6401920621974508 -9.824948557224378e-07 -0.06393833742243826 -0.4984 0.64020953530466 0.6402096049367213 -9.706462405223437e-07 -0.06394731746985992 -0.4985 0.6402270561029226 0.6402271436736163 -9.586216952739424e-07 -0.06395629577274545 -0.49860000000000004 0.6402445731332153 0.6402446784069351 -9.464234907718971e-07 -0.06396527233118887 -0.49870000000000003 0.6402620863977222 0.6402622091354986 -9.340539307567397e-07 -0.06397424714528431 -0.4988 0.640279595898606 0.6402797358581508 -9.215153516928254e-07 -0.0639832202151261 -0.4989 0.640297101638006 0.6402972585737585 -9.088101221021994e-07 -0.06399219154080862 -0.499 0.6403146036180389 0.6403147772812114 -8.959406425090854e-07 -0.06400116112242639 -0.49910000000000004 0.6403321018407979 0.6403322919794233 -8.829093444961966e-07 -0.0640101289600741 -0.49920000000000003 0.6403495963083525 0.6403498026673313 -8.697186907880017e-07 -0.06401909505384647 -0.4993 0.6403670870227489 0.6403673093438974 -8.563711741960134e-07 -0.06402805940383853 -0.4994 0.6403845739860083 0.6403848120081072 -8.428693175355217e-07 -0.0640370220101452 -0.4995 0.6404020572001277 0.6404023106589714 -8.292156732647715e-07 -0.06404598287286167 -0.49960000000000004 0.6404195366670795 0.6404198052955256 -8.154128225412727e-07 -0.06405494199208321 -0.49970000000000003 0.6404370123888107 0.6404372959168312 -8.014633751662892e-07 -0.06406389936790526 -0.4998 0.640454484367243 0.6404547825219747 -7.873699688909497e-07 -0.0640728550004233 -0.4999 0.6404719526042729 0.6404722651100684 -7.73135268986036e-07 -0.064081808889733 -0.5 0.6404894171017705 0.6404897436802508 -7.587619676313606e-07 -0.0640907610359301 -0.5001 0.6405068778615803 0.6405072182316871 -7.442527836243329e-07 -0.06409971143911057 -0.5002000000000001 0.6405243348855197 0.6405246887635686 -7.296104616444365e-07 -0.06410866009937036 -0.5003 0.6405417881753801 0.640542155275114 -7.148377718230181e-07 -0.06411760701680565 -0.5004000000000001 0.6405592377329256 0.6405596177655689 -6.999375093269533e-07 -0.0641265521915127 -0.5005 0.6405766835598931 0.640577076234206 -6.849124936231243e-07 -0.06413549562358789 -0.5006 0.6405941256579923 0.6405945306803263 -6.697655680620862e-07 -0.06414443731312777 -0.5007 0.6406115640289052 0.640611981103258 -6.544995993923441e-07 -0.06415337726022889 -0.5008 0.6406289986742859 0.6406294275023576 -6.39117477149731e-07 -0.06416231546498809 -0.5009 0.640646429595761 0.6406468698770099 -6.236221131578068e-07 -0.06417125192750221 -0.501 0.640663856794928 0.6406643082266286 -6.080164408339694e-07 -0.06418018664786833 -0.5011 0.6406812802733564 0.6406817425506552 -5.923034148980211e-07 -0.06418911962618348 -0.5012000000000001 0.6406987000325867 0.6406991728485615 -5.764860105395009e-07 -0.06419805086254499 -0.5013 0.6407161160741306 0.6407165991198469 -5.605672230568626e-07 -0.06420698035705018 -0.5014000000000001 0.6407335283994707 0.6407340213640412 -5.445500671913406e-07 -0.06421590810979658 -0.5015 0.6407509370100607 0.6407514395807032 -5.284375765579608e-07 -0.0642248341208818 -0.5016 0.6407683419073241 0.6407688537694218 -5.122328032014511e-07 -0.06423375839040357 -0.5017 0.6407857430926553 0.6407862639298153 -4.959388167635748e-07 -0.06424268091845978 -0.5018 0.6408031405674189 0.6408036700615325 -4.795587042055738e-07 -0.06425160170514842 -0.5019 0.6408205343329494 0.640821072164252 -4.6309556890611336e-07 -0.06426052075056758 -0.502 0.6408379243905504 0.6408384702376831 -4.465525303976037e-07 -0.06426943805481551 -0.5021 0.6408553107414966 0.6408558642815656 -4.299327235474104e-07 -0.06427835361799056 -0.5022000000000001 0.6408726933870311 0.6408732542956697 -4.132392980721322e-07 -0.06428726744019118 -0.5023 0.640890072328367 0.6408906402797968 -3.9647541780207796e-07 -0.064296179521516 -0.5024000000000001 0.6409074475666865 0.6409080222337789 -3.7964426035513865e-07 -0.06430508986206375 -0.5025 0.6409248191031409 0.6409254001574796 -3.627490162486091e-07 -0.06431399846193324 -0.5026 0.6409421869388505 0.6409427740507929 -3.4579288848979317e-07 -0.06432290532122346 -0.5027 0.6409595510749047 0.6409601439136453 -3.287790918682365e-07 -0.06433181044003355 -0.5028 0.6409769115123611 0.6409775097459937 -3.1171085235898177e-07 -0.06434071381846264 -0.5029 0.6409942682522466 0.6409948715478269 -2.9459140649806814e-07 -0.06434961545661007 -0.503 0.6410116212955563 0.6410122293191657 -2.774240008482365e-07 -0.06435851535457533 -0.5031 0.6410289706432539 0.6410295830600623 -2.6021189131197886e-07 -0.06436741351245798 -0.5032000000000001 0.6410463162962714 0.6410469327706008 -2.4295834255561033e-07 -0.06437630993035773 -0.5033 0.6410636582555092 0.6410642784508971 -2.2566662735007403e-07 -0.06438520460837434 -0.5034000000000001 0.6410809965218355 0.6410816201010998 -2.0834002594644074e-07 -0.0643940975466078 -0.5035 0.6410983310960873 0.6410989577213888 -1.9098182553814458e-07 -0.06440298874515818 -0.5036 0.6411156619790692 0.6411162913119764 -1.7359531953239915e-07 -0.06441187820412565 -0.5037 0.6411329891715539 0.6411336208731073 -1.5618380696733047e-07 -0.0644207659236105 -0.5038 0.6411503126742821 0.6411509464050583 -1.3875059191870154e-07 -0.06442965190371314 -0.5039 0.6411676324879625 0.6411682679081386 -1.212989828337785e-07 -0.06443853614453418 -0.504 0.6411849486132711 0.6411855853826897 -1.038322918998913e-07 -0.06444741864617423 -0.5041 0.6412022610508528 0.6412028988290857 -8.635383443207634e-08 -0.06445629940873412 -0.5042000000000001 0.641219569801319 0.6412202082477327 -6.886692823990237e-08 -0.06446517843231474 -0.5043 0.6412368748652499 0.6412375136390697 -5.1374893002102684e-08 -0.0644740557170171 -0.5044000000000001 0.641254176243193 0.641254815003568 -3.388104962429375e-08 -0.0644829312629424 -0.5045 0.6412714739356636 0.6412721123417313 -1.6388719614257932e-08 -0.06449180507019191 -0.5046 0.6412887679431447 0.6412894056540961 1.0987755488453543e-09 -0.06450067713886698 -0.5047 0.6413060582660873 0.6413066949412305 1.8578115044617927e-08 -0.06450954746906913 -0.5048 0.6413233449049097 0.6413239802037362 3.604597934372955e-08 -0.06451841606090002 -0.5049 0.6413406278599985 0.6413412614422469 5.3499050843910934e-08 -0.06452728291446141 -0.505 0.6413579071317073 0.6413585386574284 7.093401449206893e-08 -0.06453614802985515 -0.5051 0.6413751827203584 0.6413758118499797 8.834755842179742e-08 -0.06454501140718326 -0.5052000000000001 0.6413924546262414 0.6413930810206312 1.0573637458655138e-07 -0.06455387304654785 -0.5053 0.6414097228496137 0.6414103461701467 1.2309715937200427e-07 -0.06456273294805116 -0.5054000000000001 0.6414269873907008 0.6414276072993215 1.4042661425697767e-07 -0.06457159111179553 -0.5055 0.6414442482496963 0.6414448644089836 1.5772144639283892e-07 -0.06458044753788347 -0.5056 0.6414615054267614 0.641462117499993 1.749783692800433e-07 -0.06458930222641755 -0.5057 0.6414787589220261 0.6414793665732419 1.921941033614094e-07 -0.0645981551775005 -0.5058 0.6414960087355875 0.6414966116296545 2.0936537666743638e-07 -0.06460700639123516 -0.5059 0.641513254867512 0.6415138526701872 2.2648892543386534e-07 -0.06461585586772452 -0.506 0.6415304973178337 0.6415310896958281 2.435614946949549e-07 -0.0646247036070716 -0.5061 0.6415477360865554 0.6415483227075971 2.605798389565539e-07 -0.06463354960937967 -0.5062000000000001 0.6415649711736477 0.641565551706546 2.7754072279284614e-07 -0.06464239387475196 -0.5063 0.6415822025790505 0.6415827766937579 2.9444092140146205e-07 -0.06465123640329194 -0.5064000000000001 0.6415994303026725 0.6415999976703479 3.112772213320625e-07 -0.0646600771951032 -0.5065 0.6416166543443904 0.6416172146374625 3.280464210414502e-07 -0.0646689162502894 -0.5066 0.6416338747040506 0.6416344275962791 3.447453314417426e-07 -0.0646777535689543 -0.5067 0.6416510913814679 0.6416516365480065 3.613707766636498e-07 -0.06468658915120185 -0.5068 0.6416683043764269 0.6416688414938845 3.7791959449362533e-07 -0.06469542299713608 -0.5069 0.641685513688681 0.6416860424351841 3.9438863710938854e-07 -0.06470425510686116 -0.507 0.6417027193179534 0.641703239373207 4.1077477154483066e-07 -0.06471308548048137 -0.5071 0.6417199212639365 0.6417204323092849 4.2707488041859865e-07 -0.06472191411810106 -0.5072000000000001 0.6417371195262928 0.6417376212447805 4.432858625724734e-07 -0.06473074101982478 -0.5073 0.6417543141046543 0.6417548061810872 4.5940463336280324e-07 -0.06473956618575714 -0.5074000000000001 0.6417715049986235 0.6417719871196278 4.754281256597048e-07 -0.06474838961600288 -0.5075 0.641788692207773 0.6417891640618554 4.913532900829853e-07 -0.0647572113106669 -0.5076 0.6418058757316456 0.641806337009253 5.071770958486876e-07 -0.06476603126985421 -0.5077 0.6418230555697548 0.6418235059633333 5.22896531116035e-07 -0.06477484949366985 -0.5078 0.6418402317215851 0.6418406709256381 5.385086037784648e-07 -0.06478366598221912 -0.5079 0.6418574041865914 0.641857831897739 5.540103419493514e-07 -0.06479248073560731 -0.508 0.6418745729642001 0.6418749888812358 5.69398794419973e-07 -0.06480129375393988 -0.5081 0.6418917380538095 0.6418921418777581 5.846710313811565e-07 -0.06481010503732244 -0.5082000000000001 0.6419088994547884 0.6419092908889634 5.998241448812447e-07 -0.06481891458586068 -0.5083 0.6419260571664782 0.6419264359165382 6.148552495061077e-07 -0.06482772239966046 -0.5084000000000001 0.641943211188192 0.6419435769621967 6.297614828787435e-07 -0.06483652847882766 -0.5085 0.6419603615192151 0.6419607140276815 6.445400060062223e-07 -0.06484533282346835 -0.5086 0.6419775081588055 0.6419778471147627 6.591880041262321e-07 -0.06485413543368873 -0.5087 0.6419946511061937 0.641994976225238 6.737026871095342e-07 -0.06486293630959508 -0.5088 0.642011790360583 0.6420121013609323 6.880812900428301e-07 -0.06487173545129381 -0.5089 0.6420289259211502 0.6420292225236979 7.023210735757068e-07 -0.06488053285889143 -0.509 0.6420460577870455 0.642046339715413 7.164193247255479e-07 -0.06488932853249461 -0.5091 0.6420631859573924 0.6420634529379833 7.303733572383564e-07 -0.06489812247221009 -0.5092000000000001 0.6420803104312889 0.6420805621933403 7.441805120744771e-07 -0.06490691467814481 -0.5093 0.6420974312078069 0.6420976674834414 7.578381579775861e-07 -0.06491570515040572 -0.5094000000000001 0.6421145482859928 0.6421147688102701 7.71343692113069e-07 -0.06492449388909997 -0.5095 0.6421316616648676 0.6421318661758348 7.846945401790428e-07 -0.06493328089433474 -0.5096 0.642148771343428 0.6421489595821696 7.978881572667795e-07 -0.06494206616621744 -0.5097 0.6421658773206451 0.6421660490313331 8.109220283325502e-07 -0.06495084970485551 -0.5098 0.6421829795954666 0.6421831345254088 8.237936684751812e-07 -0.0649596315103566 -0.5099 0.6422000781668153 0.6422002160665041 8.365006236576988e-07 -0.06496841158282832 -0.51 0.6422171730335908 0.6422172936567507 8.49040470679574e-07 -0.06497718992237854 -0.5101 0.642234264194669 0.642234367298304 8.614108183979674e-07 -0.06498596652911524 -0.5102000000000001 0.6422513516489023 0.6422514369933425 8.736093076444629e-07 -0.06499474140314641 -0.5103 0.6422684353951212 0.6422685027440679 8.856336117801789e-07 -0.0650035145445803 -0.5104000000000001 0.6422855154321326 0.6422855645527047 8.974814372231243e-07 -0.06501228595352514 -0.5105 0.642302591758722 0.6423026224214997 9.091505238090214e-07 -0.06502105563008939 -0.5106 0.6423196643736524 0.642319676352722 9.206386453741722e-07 -0.06502982357438157 -0.5107 0.6423367332756655 0.6423367263486622 9.319436100607703e-07 -0.06503858978651025 -0.5108 0.642353798463482 0.6423537724116324 9.430632606777234e-07 -0.06504735426658427 -0.5109 0.6423708599358015 0.6423708145439658 9.539954753667867e-07 -0.0650561170147125 -0.511 0.642387917691303 0.6423878527480167 9.647381676580746e-07 -0.06506487803100393 -0.5111 0.6424049717286455 0.642404887026159 9.752892870806829e-07 -0.06507363731556769 -0.5112000000000001 0.6424220220464683 0.6424219173807875 9.856468197733115e-07 -0.06508239486851293 -0.5113 0.6424390686433906 0.6424389438143158 9.958087882344646e-07 -0.06509115068994907 -0.5114000000000001 0.6424561115180134 0.6424559663291776 1.0057732525436958e-06 -0.06509990477998558 -0.5115 0.6424731506689183 0.6424729849278252 1.0155383099452742e-06 -0.06510865713873201 -0.5116 0.6424901860946683 0.6424899996127293 1.0251020957641188e-06 -0.06511740776629803 -0.5117 0.6425072177938093 0.6425070103863795 1.034462783572332e-06 -0.06512615666279346 -0.5118 0.6425242457648686 0.6425240172512825 1.0436185854112434e-06 -0.06513490382832826 -0.5119 0.6425412700063566 0.642541020209963 1.052567752318767e-06 -0.06514364926301247 -0.512 0.6425582905167674 0.6425580192649623 1.0613085747179785e-06 -0.06515239296695623 -0.5121 0.6425753072945778 0.6425750144188387 1.0698393825836483e-06 -0.0651611349402698 -0.5122000000000001 0.6425923203382486 0.6425920056741669 1.0781585457753096e-06 -0.06516987518306364 -0.5123000000000001 0.6426093296462254 0.6426089930335377 1.0862644743980798e-06 -0.0651786136954482 -0.5124 0.6426263352169377 0.6426259764995566 1.094155619218995e-06 -0.0651873504775341 -0.5125 0.6426433370488008 0.6426429560748452 1.1018304718612981e-06 -0.06519608552943215 -0.5126000000000001 0.642660335140215 0.6426599317620394 1.10928756505424e-06 -0.06520481885125314 -0.5127 0.6426773294895667 0.6426769035637891 1.1165254729939011e-06 -0.06521355044310806 -0.5128 0.6426943200952284 0.642693871482759 1.1235428115929924e-06 -0.06522228030510799 -0.5129 0.6427113069555596 0.6427108355216264 1.130338238591877e-06 -0.06523100843736412 -0.513 0.6427282900689064 0.6427277956830824 1.1369104542802155e-06 -0.0652397348399878 -0.5131 0.6427452694336028 0.6427447519698302 1.1432582013304327e-06 -0.06524845951309045 -0.5132000000000001 0.6427622450479706 0.6427617043845857 1.1493802650197615e-06 -0.06525718245678362 -0.5133000000000001 0.6427792169103199 0.6427786529300766 1.1552754737853554e-06 -0.06526590367117897 -0.5134 0.6427961850189496 0.6427955976090423 1.1609426992520433e-06 -0.06527462315638828 -0.5135 0.6428131493721481 0.6428125384242325 1.1663808564821299e-06 -0.06528334091252347 -0.5136000000000001 0.6428301099681928 0.6428294753784081 1.1715889040309069e-06 -0.06529205693969656 -0.5137 0.6428470668053516 0.6428464084743398 1.1765658445017646e-06 -0.06530077123801963 -0.5138 0.6428640198818825 0.6428633377148084 1.181310724407414e-06 -0.06530948380760492 -0.5139 0.6428809691960347 0.6428802631026039 1.18582263458622e-06 -0.06531819464856481 -0.514 0.6428979147460484 0.6428971846405251 1.19010071034098e-06 -0.06532690376101179 -0.5141 0.6429148565301563 0.642914102331379 1.1941441313556567e-06 -0.06533561114505841 -0.5142 0.6429317945465823 0.6429310161779811 1.197952122222734e-06 -0.06534431680081738 -0.5143000000000001 0.6429487287935437 0.6429479261831541 1.2015239524432175e-06 -0.06535302072840153 -0.5144 0.6429656592692505 0.6429648323497279 1.2048589365099005e-06 -0.0653617229279238 -0.5145 0.6429825859719064 0.6429817346805392 1.2079564340461424e-06 -0.06537042339949717 -0.5146000000000001 0.6429995088997085 0.6429986331784309 1.2108158500556687e-06 -0.06537912214323485 -0.5147 0.6430164280508491 0.6430155278462517 1.2134366348948156e-06 -0.0653878191592501 -0.5148 0.643033343423515 0.6430324186868556 1.2158182847443744e-06 -0.0653965144476563 -0.5149 0.6430502550158881 0.6430493057031016 1.2179603410544804e-06 -0.06540520800856697 -0.515 0.6430671628261467 0.643066188897853 1.2198623910719686e-06 -0.06541389984209577 -0.5151 0.6430840668524644 0.6430830682739774 1.2215240680624184e-06 -0.0654225899483564 -0.5152 0.6431009670930119 0.6430999438343457 1.222945051088109e-06 -0.06543127832746264 -0.5153000000000001 0.643117863545957 0.6431168155818321 1.2241250650635305e-06 -0.06543996497952852 -0.5154 0.6431347562094649 0.6431336835193133 1.2250638810884507e-06 -0.0654486499046681 -0.5155 0.6431516450816986 0.6431505476496686 1.2257613161703595e-06 -0.0654573331029956 -0.5156000000000001 0.6431685301608201 0.6431674079757785 1.2262172336130472e-06 -0.06546601457462527 -0.5157 0.6431854114449895 0.6431842645005252 1.2264315426557815e-06 -0.06547469431967154 -0.5158 0.6432022889323671 0.6432011172267917 1.22640419883413e-06 -0.06548337233824894 -0.5159 0.643219162621112 0.6432179661574613 1.2261352038411832e-06 -0.0654920486304721 -0.516 0.6432360325093844 0.6432348112954177 1.2256246055275533e-06 -0.06550072319645582 -0.5161 0.643252898595345 0.6432516526435434 1.2248724979013748e-06 -0.06550939603631493 -0.5162 0.6432697608771552 0.6432684902047208 1.2238790212115713e-06 -0.06551806715016446 -0.5163000000000001 0.643286619352978 0.6432853239818299 1.2226443618090777e-06 -0.06552673653811947 -0.5164 0.6433034740209794 0.6433021539777497 1.2211687520635728e-06 -0.06553540420029516 -0.5165 0.6433203248793267 0.6433189801953565 1.2194524706132803e-06 -0.06554407013680684 -0.5166000000000001 0.6433371719261907 0.6433358026375242 1.2174958419486348e-06 -0.06555273434777001 -0.5167 0.6433540151597456 0.6433526213071231 1.2152992366065707e-06 -0.06556139683330019 -0.5168 0.6433708545781696 0.6433694362070204 1.2128630710317445e-06 -0.06557005759351309 -0.5169 0.6433876901796443 0.6433862473400783 1.2101878075487793e-06 -0.06557871662852442 -0.517 0.643404521962357 0.6434030547091555 1.2072739540014421e-06 -0.06558737393845007 -0.5171 0.6434213499245001 0.643419858317105 1.204122064335511e-06 -0.06559602952340608 -0.5172 0.6434381740642711 0.6434366581667748 1.200732737571819e-06 -0.06560468338350857 -0.5173000000000001 0.643454994379874 0.6434534542610064 1.1971066184723878e-06 -0.06561333551887377 -0.5174 0.6434718108695192 0.6434702466026356 1.193244396902049e-06 -0.06562198592961797 -0.5175 0.643488623531424 0.6434870351944912 1.1891468082170231e-06 -0.06563063461585768 -0.5176000000000001 0.6435054323638132 0.6435038200393953 1.1848146326542963e-06 -0.0656392815777095 -0.5177 0.6435222373649194 0.6435206011401613 1.1802486953038649e-06 -0.06564792681529007 -0.5178 0.6435390385329833 0.6435373784995955 1.175449866192002e-06 -0.06565657032871615 -0.5179 0.6435558358662549 0.6435541521204949 1.1704190598649244e-06 -0.06566521211810471 -0.518 0.6435726293629924 0.6435709220056478 1.1651572353332806e-06 -0.06567385218357268 -0.5181 0.6435894190214647 0.6435876881578335 1.1596653958778624e-06 -0.06568249052523727 -0.5182 0.6436062048399498 0.6436044505798209 1.1539445888275601e-06 -0.06569112714321566 -0.5183000000000001 0.6436229868167368 0.643621209274369 1.1479959053650735e-06 -0.06569976203762531 -0.5184 0.6436397649501251 0.643637964244226 1.1418204803603782e-06 -0.06570839520858356 -0.5185 0.6436565392384258 0.6436547154921292 1.1354194921764371e-06 -0.06571702665620807 -0.5186000000000001 0.643673309679962 0.6436714630208037 1.1287941623083775e-06 -0.06572565638061649 -0.5187 0.6436900762730684 0.6436882068329632 1.12194575557778e-06 -0.06573428438192669 -0.5188 0.6437068390160925 0.6437049469313094 1.1148755791612341e-06 -0.06574291066025653 -0.5189 0.643723597907395 0.64372168331853 1.1075849830066709e-06 -0.06575153521572406 -0.519 0.6437403529453495 0.6437384159973005 1.1000753592504964e-06 -0.06576015804844741 -0.5191 0.6437571041283439 0.6437551449702825 1.092348142078814e-06 -0.06576877915854484 -0.5192 0.6437738514547802 0.6437718702401231 1.0844048074776236e-06 -0.06577739854613467 -0.5193000000000001 0.643790594923075 0.6437885918094557 1.076246872788733e-06 -0.06578601621133545 -0.5194 0.6438073345316602 0.6438053096808982 1.0678758965432245e-06 -0.06579463215426576 -0.5195 0.6438240702789827 0.6438220238570539 1.059293478322676e-06 -0.06580324637504424 -0.5196000000000001 0.6438408021635056 0.6438387343405095 1.0505012581762951e-06 -0.06581185887378975 -0.5197 0.6438575301837078 0.6438554411338364 1.041500916287852e-06 -0.06582046965062115 -0.5198 0.6438742543380858 0.6438721442395893 1.032294172947923e-06 -0.06582907870565752 -0.5199 0.6438909746251521 0.643888843660306 1.0228827880542912e-06 -0.06583768603901802 -0.52 0.643907691043437 0.6439055393985074 1.0132685609176573e-06 -0.06584629165082186 -0.5201 0.643924403591489 0.643922231456696 1.0034533296232606e-06 -0.06585489554118842 -0.5202 0.643941112267874 0.6439389198373576 9.934389710031244e-07 -0.06586349771023721 -0.5203000000000001 0.6439578170711773 0.6439556045429583 9.83227399997677e-07 -0.06587209815808778 -0.5204 0.6439745180000027 0.643972285575946 9.728205696002412e-07 -0.06588069688485984 -0.5205 0.643991215052973 0.6439889629387495 9.622204701908998e-07 -0.0658892938906732 -0.5206000000000001 0.6440079082287314 0.6440056366337783 9.51429129425474e-07 -0.0658978891756478 -0.5207 0.6440245975259409 0.6440223066634218 9.404486116526556e-07 -0.06590648273990367 -0.5208 0.6440412829432843 0.644038973030049 9.292810176086963e-07 -0.06591507458356094 -0.5209 0.644057964479466 0.6440556357360089 9.179284839733182e-07 -0.06592366470673987 -0.521 0.644074642133211 0.644072294783629 9.063931830088912e-07 -0.06593225310956083 -0.5211 0.6440913159032657 0.6440889501752158 8.946773220330773e-07 -0.06594083979214425 -0.5212 0.6441079857883986 0.6441056019130542 8.827831432800526e-07 -0.06594942475461074 -0.5213000000000001 0.6441246517874 0.6441222499994071 8.707129232343735e-07 -0.06595800799708103 -0.5214 0.6441413138990832 0.6441388944365153 8.584689722423988e-07 -0.06596658951967589 -0.5215 0.6441579721222841 0.6441555352265965 8.460536340404445e-07 -0.06597516932251625 -0.5216000000000001 0.6441746264558614 0.6441721723718461 8.334692853939618e-07 -0.06598374740572314 -0.5217 0.6441912768986977 0.6441888058744359 8.207183355701808e-07 -0.06599232376941773 -0.5218 0.6442079234496987 0.6442054357365139 8.078032259495327e-07 -0.06600089841372118 -0.5219 0.644224566107795 0.6442220619602045 7.947264294982936e-07 -0.06600947133875491 -0.522 0.644241204871941 0.644238684547608 7.814904504077624e-07 -0.06601804254464039 -0.5221 0.6442578397411162 0.6442553035007998 7.680978234281266e-07 -0.0660266120314992 -0.5222 0.6442744707143246 0.6442719188218309 7.545511136186622e-07 -0.06603517979945298 -0.5223000000000001 0.644291097790596 0.6442885305127267 7.408529155983334e-07 -0.06604374584862353 -0.5224 0.6443077209689856 0.6443051385754881 7.270058532959922e-07 -0.06605231017913282 -0.5225 0.6443243402485745 0.6443217430120892 7.130125793120001e-07 -0.06606087279110287 -0.5226000000000001 0.6443409556284699 0.6443383438244787 6.988757743353613e-07 -0.06606943368465572 -0.5227 0.6443575671078052 0.6443549410145792 6.845981469216778e-07 -0.06607799285991366 -0.5228 0.6443741746857409 0.6443715345842866 6.701824326882377e-07 -0.06608655031699902 -0.5229 0.644390778361464 0.6443881245354699 6.556313939254377e-07 -0.06609510605603428 -0.523 0.6444073781341892 0.644404710869971 6.409478190555484e-07 -0.06610366007714194 -0.5231 0.6444239740031587 0.6444212935896053 6.261345220498482e-07 -0.06611221238044475 -0.5232 0.6444405659676415 0.6444378726961597 6.111943418873889e-07 -0.06612076296606544 -0.5233000000000001 0.6444571540269358 0.6444544481913939 5.96130142221929e-07 -0.06612931183412694 -0.5234 0.6444737381803674 0.644471020077039 5.809448104659998e-07 -0.06613785898475222 -0.5235 0.6444903184272902 0.6444875883547987 5.656412575272274e-07 -0.0661464044180644 -0.5236000000000001 0.6445068947670876 0.6445041530263478 5.502224172115877e-07 -0.06615494813418675 -0.5237 0.6445234671991712 0.6445207140933317 5.346912455989061e-07 -0.0661634901332425 -0.5238 0.644540035722982 0.6445372715573677 5.190507204738681e-07 -0.06617203041535513 -0.5239 0.6445566003379903 0.6445538254200438 5.033038407015189e-07 -0.0661805689806482 -0.524 0.644573161043696 0.644570375682919 4.874536258941964e-07 -0.06618910582924535 -0.5241 0.6445897178396284 0.6445869223475219 4.7150311555110846e-07 -0.06619764096127037 -0.5242 0.6446062707253473 0.6446034654153521 4.554553685726104e-07 -0.06620617437684712 -0.5243000000000001 0.6446228197004418 0.644620004887879 4.393134628022377e-07 -0.06621470607609957 -0.5244 0.6446393647645323 0.6446365407665415 4.230804942634281e-07 -0.06622323605915183 -0.5245 0.6446559059172688 0.6446530730527491 4.0675957668767637e-07 -0.06623176432612807 -0.5246000000000001 0.6446724431583326 0.64466960174788 3.9035384087615643e-07 -0.06624029087715262 -0.5247 0.6446889764874351 0.644686126853282 3.738664340474651e-07 -0.06624881571234986 -0.5248 0.6447055059043191 0.644702648370272 3.573005192131218e-07 -0.06625733883184431 -0.5248999999999999 0.644722031408759 0.6447191663001368 3.406592747612347e-07 -0.06626586023576068 -0.525 0.6447385530005594 0.6447356806441311 3.239458936793449e-07 -0.06627437992422362 -0.5251 0.6447550706795573 0.6447521914034786 3.071635829715591e-07 -0.06628289789735801 -0.5252 0.6447715844456205 0.6447686985793719 2.903155631034382e-07 -0.06629141415528883 -0.5253000000000001 0.644788094298649 0.6447852021729719 2.73405067301169e-07 -0.0662999286981411 -0.5254 0.6448046002385746 0.6448017021854077 2.5643534096175813e-07 -0.06630844152603999 -0.5255 0.6448211022653607 0.6448181986177772 2.3940964108404295e-07 -0.06631695263911082 -0.5256000000000001 0.6448376003790028 0.6448346914711459 2.2233123557480194e-07 -0.06632546203747897 -0.5257000000000001 0.6448540945795291 0.6448511807465475 2.0520340266588777e-07 -0.06633396972126991 -0.5258 0.6448705848669991 0.6448676664449837 1.8802943024115448e-07 -0.06634247569060925 -0.5258999999999999 0.6448870712415055 0.6448841485674238 1.7081261529522385e-07 -0.06635097994562268 -0.526 0.6449035537031728 0.6449006271148051 1.5355626312857362e-07 -0.06635948248643604 -0.5261 0.6449200322521585 0.6449171020880327 1.362636869277345e-07 -0.06636798331317527 -0.5262 0.6449365068886526 0.6449335734879789 1.1893820694650059e-07 -0.0663764824259664 -0.5263000000000001 0.6449529776128773 0.6449500413154838 1.0158314999939022e-07 -0.06638497982493556 -0.5264 0.644969444425088 0.6449665055713547 8.42018487608176e-08 -0.06639347551020895 -0.5265 0.6449859073255727 0.6449829662563666 6.679764110242847e-08 -0.066401969481913 -0.5266000000000001 0.6450023663146525 0.6449994233712619 4.937386953104972e-08 -0.06641046174017413 -0.5267000000000001 0.6450188213926807 0.6450158769167501 3.1933880447962415e-08 -0.06641895228511893 -0.5268 0.6450352725600441 0.6450323268935079 1.4481023586851438e-08 -0.06642744111687404 -0.5268999999999999 0.6450517198171623 0.6450487733021792 -2.981348667940864e-09 -0.0664359282355663 -0.527 0.6450681631644877 0.6450652161433754 -2.0449881911986656e-08 -0.06644441364132253 -0.5271 0.6450846026025058 0.645081655417675 -3.7921220379967535e-08 -0.06645289733426978 -0.5272 0.6451010381317351 0.6450980911256239 -5.5392007580529114e-08 -0.06646137931453514 -0.5273000000000001 0.6451174697527271 0.6451145232677347 -7.285888694100184e-08 -0.06646985958224577 -0.5274 0.6451338974660662 0.6451309518444871 -9.031850245911494e-08 -0.06647833813752907 -0.5275 0.6451503212723702 0.6451473768563287 -1.0776749934278407e-07 -0.06648681498051243 -0.5276000000000001 0.645166741172289 0.6451637983036738 -1.2520252465515747e-07 -0.06649529011132335 -0.5277000000000001 0.6451831571665064 0.6451802161869038 -1.4262022797646712e-07 -0.0665037635300895 -0.5278 0.6451995692557387 0.6451966305063677 -1.6001726201378408e-07 -0.0665122352369386 -0.5278999999999999 0.6452159774407351 0.6452130412623817 -1.7739028329230577e-07 -0.0665207052319985 -0.528 0.6452323817222778 0.6452294484552291 -1.947359527312842e-07 -0.06652917351539721 -0.5281 0.6452487821011814 0.6452458520851605 -2.1205093637260974e-07 -0.06653764008726269 -0.5282 0.6452651785782937 0.6452622521523943 -2.2933190596541309e-07 -0.06654610494772319 -0.5283000000000001 0.6452815711544954 0.6452786486571164 -2.4657553961138223e-07 -0.06655456809690699 -0.5284 0.6452979598306992 0.6452950415994797 -2.6377852242048805e-07 -0.06656302953494242 -0.5285 0.6453143446078509 0.6453114309796049 -2.809375471493625e-07 -0.06657148926195798 -0.5286000000000001 0.6453307254869285 0.6453278167975803 -2.98049314825799e-07 -0.0665799472780823 -0.5287000000000001 0.6453471024689428 0.6453441990534626 -3.1511053536631417e-07 -0.06658840358344402 -0.5288 0.6453634755549363 0.6453605777472755 -3.321179283047315e-07 -0.06659685817817197 -0.5288999999999999 0.6453798447459844 0.6453769528790109 -3.490682232987208e-07 -0.06660531106239506 -0.529 0.6453962100431941 0.6453933244486291 -3.659581608098095e-07 -0.0666137622362423 -0.5291 0.6454125714477049 0.6454096924560581 -3.827844927348223e-07 -0.06662221169984284 -0.5292 0.6454289289606878 0.6454260569011943 -3.9954398309977046e-07 -0.06663065945332587 -0.5293000000000001 0.645445282583346 0.6454424177839025 -4.1623340854557433e-07 -0.06663910549682074 -0.5294 0.645461632316914 0.6454587751040161 -4.328495590774639e-07 -0.06664754983045688 -0.5295 0.6454779781626578 0.645475128861337 -4.493892386270293e-07 -0.06665599245436384 -0.5296000000000001 0.6454943201218752 0.6454914790556356 -4.6584926563508766e-07 -0.06666443336867124 -0.5297000000000001 0.6455106581958948 0.6455078256866521 -4.822264737108783e-07 -0.06667287257350885 -0.5298 0.6455269923860769 0.6455241687540946 -4.985177123190132e-07 -0.06668131006900653 -0.5298999999999999 0.6455433226938122 0.6455405082576414 -5.147198471888714e-07 -0.06668974585529429 -0.53 0.6455596491205223 0.6455568441969398 -5.308297610917556e-07 -0.06669817993250214 -0.5301 0.6455759716676597 0.6455731765716065 -5.468443543821255e-07 -0.06670661230076029 -0.5302 0.6455922903367067 0.6455895053812282 -5.627605456498541e-07 -0.06671504296019896 -0.5303000000000001 0.6456086051291767 0.6456058306253611 -5.785752721643167e-07 -0.06672347191094861 -0.5304 0.6456249160466125 0.6456221523035321 -5.942854906515471e-07 -0.06673189915313969 -0.5305 0.6456412230905872 0.6456384704152378 -6.098881778215937e-07 -0.06674032468690277 -0.5306000000000001 0.6456575262627036 0.6456547849599455 -6.253803307709749e-07 -0.0667487485123686 -0.5307000000000001 0.6456738255645937 0.6456710959370933 -6.407589679957582e-07 -0.06675717062966793 -0.5308 0.6456901209979191 0.6456874033460901 -6.560211294470708e-07 -0.06676559103893175 -0.5308999999999999 0.64570641256437 0.645703707186316 -6.711638774331563e-07 -0.06677400974029099 -0.531 0.6457227002656659 0.6457200074571219 -6.861842972161192e-07 -0.06678242673387676 -0.5311 0.6457389841035548 0.6457363041578311 -7.010794972894807e-07 -0.06679084201982036 -0.5312 0.6457552640798131 0.645752597287738 -7.158466102663574e-07 -0.06679925559825306 -0.5313000000000001 0.645771540196245 0.6457688868461092 -7.304827931847724e-07 -0.06680766746930629 -0.5314 0.6457878124546832 0.6457851728321838 -7.449852282293001e-07 -0.06681607763311158 -0.5315 0.6458040808569878 0.6458014552451731 -7.59351123105767e-07 -0.06682448608980061 -0.5316000000000001 0.6458203454050464 0.645817734084261 -7.735777118045295e-07 -0.0668328928395051 -0.5317000000000001 0.6458366061007734 0.6458340093486052 -7.876622549196632e-07 -0.06684129788235686 -0.5318 0.6458528629461104 0.6458502810373357 -8.01602040315097e-07 -0.0668497012184879 -0.5318999999999999 0.6458691159430259 0.6458665491495564 -8.153943836658462e-07 -0.06685810284803023 -0.532 0.645885365093514 0.6458828136843456 -8.290366287078133e-07 -0.06686650277111605 -0.5321 0.6459016103995956 0.6458990746407547 -8.425261482369883e-07 -0.06687490098787759 -0.5322 0.6459178518633168 0.6459153320178104 -8.558603441510826e-07 -0.06688329749844721 -0.5323000000000001 0.6459340894867494 0.6459315858145132 -8.69036648309951e-07 -0.06689169230295737 -0.5324 0.6459503232719909 0.6459478360298392 -8.820525227160037e-07 -0.06690008540154067 -0.5325 0.6459665532211631 0.6459640826627395 -8.949054601248285e-07 -0.0669084767943298 -0.5326000000000001 0.6459827793364126 0.645980325712141 -9.07592984850103e-07 -0.06691686648145752 -0.5327000000000001 0.6459990016199102 0.6459965651769461 -9.201126527080827e-07 -0.06692525446305671 -0.5328 0.6460152200738509 0.6460128010560338 -9.324620518502691e-07 -0.06693364073926035 -0.5328999999999999 0.6460314347004532 0.6460290333482589 -9.446388030687203e-07 -0.06694202531020155 -0.533 0.646047645501959 0.6460452620524537 -9.566405605176964e-07 -0.06695040817601348 -0.5331 0.6460638524806331 0.6460614871674277 -9.684650116026372e-07 -0.06695878933682947 -0.5332 0.6460800556387633 0.6460777086919673 -9.80109878090385e-07 -0.06696716879278289 -0.5333000000000001 0.6460962549786593 0.6460939266248373 -9.915729162479625e-07 -0.06697554654400727 -0.5334 0.6461124505026534 0.6461101409647803 -1.0028519171478845e-06 -0.06698392259063621 -0.5335 0.6461286422130987 0.646126351710517 -1.013944707334291e-06 -0.06699229693280338 -0.5336000000000001 0.6461448301123706 0.6461425588607481 -1.024849149044993e-06 -0.06700066957064264 -0.5337000000000001 0.6461610142028645 0.6461587624141524 -1.0355631409331156e-06 -0.06700904050428784 -0.5338 0.6461771944869974 0.6461749623693888 -1.0460846181781225e-06 -0.06701740973387309 -0.5338999999999999 0.6461933709672057 0.646191158725096 -1.0564115530964369e-06 -0.06702577725953245 -0.534 0.6462095436459464 0.6462073514798929 -1.0665419550859312e-06 -0.06703414308140017 -0.5341 0.6462257125256953 0.6462235406323793 -1.0764738716806388e-06 -0.06704250719961055 -0.5342 0.6462418776089477 0.6462397261811357 -1.086205388411976e-06 -0.06705086961429803 -0.5343000000000001 0.6462580388982178 0.6462559081247241 -1.095734629474876e-06 -0.06705923032559712 -0.5344 0.6462741963960379 0.6462720864616883 -1.1050597581163668e-06 -0.06706758933364247 -0.5345 0.6462903501049586 0.6462882611905543 -1.1141789766910826e-06 -0.06707594663856883 -0.5346000000000001 0.6463065000275479 0.6463044323098305 -1.1230905271886193e-06 -0.067084302240511 -0.5347000000000001 0.6463226461663911 0.6463205998180085 -1.1317926916776244e-06 -0.06709265613960397 -0.5348 0.6463387885240903 0.6463367637135629 -1.1402837924445741e-06 -0.06710100833598275 -0.5348999999999999 0.646354927103264 0.6463529239949524 -1.148562192576641e-06 -0.06710935882978246 -0.535 0.6463710619065469 0.6463690806606195 -1.1566262960172047e-06 -0.06711770762113836 -0.5351 0.6463871929365893 0.6463852337089911 -1.164474547926675e-06 -0.06712605471018585 -0.5352 0.6464033201960564 0.6464013831384798 -1.1721054351265803e-06 -0.06713440009706033 -0.5353000000000001 0.6464194436876289 0.6464175289474827 -1.1795174864326352e-06 -0.0671427437818974 -0.5354 0.6464355634140011 0.646433671134383 -1.186709272599229e-06 -0.06715108576483264 -0.5355 0.6464516793778817 0.64644980969755 -1.193679407013315e-06 -0.06715942604600185 -0.5356000000000001 0.646467791581993 0.6464659446353396 -1.2004265456666552e-06 -0.06716776462554087 -0.5357000000000001 0.6464839000290705 0.6464820759460947 -1.2069493875721538e-06 -0.06717610150358568 -0.5358 0.6465000047218622 0.6464982036281459 -1.213246674958146e-06 -0.0671844366802723 -0.5358999999999999 0.6465161056631286 0.6465143276798113 -1.2193171936014657e-06 -0.06719277015573694 -0.536 0.6465322028556417 0.6465304480993974 -1.2251597728274444e-06 -0.06720110193011584 -0.5361 0.6465482963021856 0.6465465648851992 -1.2307732862315568e-06 -0.06720943200354534 -0.5362 0.6465643860055549 0.6465626780355015 -1.2361566512630873e-06 -0.06721776037616195 -0.5363000000000001 0.6465804719685551 0.6465787875485778 -1.2413088300300412e-06 -0.06722608704810222 -0.5364 0.6465965541940015 0.6465948934226924 -1.2462288290215895e-06 -0.06723441201950282 -0.5365 0.6466126326847191 0.6466109956560994 -1.250915699524402e-06 -0.0672427352905005 -0.5366000000000001 0.6466287074435428 0.6466270942470445 -1.25536853798347e-06 -0.06725105686123216 -0.5367000000000001 0.6466447784733156 0.6466431891937638 -1.2595864858633288e-06 -0.06725937673183474 -0.5368 0.6466608457768892 0.6466592804944862 -1.263568730036635e-06 -0.06726769490244534 -0.5368999999999999 0.646676909357123 0.6466753681474322 -1.2673145026731447e-06 -0.06727601137320115 -0.537 0.6466929692168841 0.6466914521508152 -1.2708230818503363e-06 -0.06728432614423936 -0.5371 0.6467090253590468 0.6467075325028417 -1.2740937913036099e-06 -0.06729263921569748 -0.5372 0.6467250777864915 0.6467236092017115 -1.2771260006205765e-06 -0.06730095058771284 -0.5373000000000001 0.646741126502105 0.6467396822456186 -1.2799191254631026e-06 -0.06730926026042308 -0.5374 0.64675717150878 0.6467557516327519 -1.282472627789355e-06 -0.0673175682339659 -0.5375 0.6467732128094139 0.6467718173612945 -1.2847860156317559e-06 -0.06732587450847904 -0.5376000000000001 0.6467892504069093 0.6467878794294253 -1.2868588436520945e-06 -0.06733417908410037 -0.5377000000000001 0.646805284304173 0.6468039378353192 -1.2886907126419267e-06 -0.06734248196096793 -0.5378000000000001 0.6468213145041155 0.6468199925771472 -1.2902812702442201e-06 -0.06735078313921976 -0.5378999999999999 0.646837341009651 0.6468360436530769 -1.2916302105925315e-06 -0.06735908261899404 -0.538 0.6468533638236961 0.6468520910612733 -1.2927372745052956e-06 -0.06736738040042903 -0.5381 0.6468693829491705 0.646868134799899 -1.2936022494858257e-06 -0.0673756764836631 -0.5382 0.6468853983889955 0.646884174867115 -1.294224969722313e-06 -0.06738397086883478 -0.5383000000000001 0.6469014101460943 0.6469002112610807 -1.2946053165041604e-06 -0.06739226355608263 -0.5384 0.646917418223391 0.6469162439799542 -1.2947432176668716e-06 -0.06740055454554533 -0.5385 0.6469334226238102 0.6469322730218936 -1.2946386482026728e-06 -0.06740884383736165 -0.5386 0.6469494233502766 0.6469482983850571 -1.2942916296776463e-06 -0.06741713143167048 -0.5387000000000001 0.6469654204057151 0.6469643200676027 -1.2937022308701085e-06 -0.06742541732861078 -0.5388000000000001 0.6469814137930496 0.64698033806769 -1.2928705671322316e-06 -0.06743370152832161 -0.5388999999999999 0.6469974035152027 0.6469963523834794 -1.2917968006675995e-06 -0.06744198403094219 -0.539 0.6470133895750954 0.6470123630131334 -1.2904811406144745e-06 -0.06745026483661179 -0.5391 0.6470293719756466 0.6470283699548167 -1.2889238428792638e-06 -0.06745854394546977 -0.5392 0.6470453507197724 0.6470443732066968 -1.2871252101365194e-06 -0.06746682135765561 -0.5393000000000001 0.6470613258103864 0.6470603727669446 -1.2850855914958714e-06 -0.06747509707330888 -0.5394 0.6470772972503982 0.6470763686337342 -1.2828053830571395e-06 -0.0674833710925693 -0.5395 0.6470932650427133 0.6470923608052441 -1.2802850272719546e-06 -0.06749164341557659 -0.5396 0.6471092291902332 0.6471083492796574 -1.2775250129715143e-06 -0.06749991404247069 -0.5397000000000001 0.6471251896958543 0.6471243340551622 -1.2745258755331168e-06 -0.0675081829733915 -0.5398000000000001 0.6471411465624679 0.6471403151299518 -1.2712881964915823e-06 -0.06751645020847913 -0.5398999999999999 0.6471570997929592 0.6471562925022261 -1.2678126036225201e-06 -0.06752471574787373 -0.54 0.6471730493902074 0.6471722661701905 -1.2640997706370172e-06 -0.06753297959171559 -0.5401 0.6471889953570847 0.6471882361320582 -1.2601504174036826e-06 -0.06754124174014511 -0.5402 0.6472049376964566 0.6472042023860489 -1.2559653093657808e-06 -0.0675495021933027 -0.5403000000000001 0.6472208764111804 0.6472201649303906 -1.2515452576244979e-06 -0.06755776095132894 -0.5404 0.6472368115041056 0.6472361237633192 -1.2468911188001641e-06 -0.0675660180143645 -0.5405 0.6472527429780738 0.6472520788830793 -1.2420037948102092e-06 -0.06757427338255016 -0.5406 0.6472686708359167 0.647268030287925 -1.2368842328969176e-06 -0.06758252705602678 -0.5407000000000001 0.647284595080457 0.6472839779761193 -1.2315334252110954e-06 -0.06759077903493531 -0.5408000000000001 0.6473005157145078 0.6472999219459351 -1.2259524085900253e-06 -0.06759902931941678 -0.5408999999999999 0.6473164327408716 0.6473158621956567 -1.2201422645019555e-06 -0.06760727790961239 -0.541 0.6473323461623406 0.6473317987235783 -1.2141041188240553e-06 -0.0676155248056634 -0.5411 0.6473482559816953 0.6473477315280057 -1.2078391416758816e-06 -0.06762377000771116 -0.5412 0.6473641622017052 0.6473636606072566 -1.2013485470308005e-06 -0.0676320135158971 -0.5413000000000001 0.6473800648251273 0.6473795859596605 -1.1946335925216989e-06 -0.0676402553303628 -0.5414 0.6473959638547063 0.64739550758356 -1.1876955794687394e-06 -0.06764849545124989 -0.5415 0.6474118592931742 0.6474114254773103 -1.1805358522409826e-06 -0.06765673387870012 -0.5416 0.6474277511432496 0.6474273396392802 -1.173155798367409e-06 -0.06766497061285537 -0.5417000000000001 0.6474436394076372 0.6474432500678525 -1.1655568479262968e-06 -0.06767320565385758 -0.5418000000000001 0.647459524089028 0.6474591567614237 -1.1577404735729768e-06 -0.06768143900184874 -0.5418999999999999 0.6474754051900977 0.6474750597184058 -1.1497081900124773e-06 -0.06768967065697101 -0.542 0.6474912827135083 0.6474909589372252 -1.1414615538052342e-06 -0.06769790061936667 -0.5421 0.6475071566619051 0.6475068544163244 -1.1330021632283138e-06 -0.06770612888917803 -0.5422 0.6475230270379179 0.6475227461541614 -1.1243316576370344e-06 -0.06771435546654746 -0.5423000000000001 0.6475388938441611 0.6475386341492111 -1.1154517174094547e-06 -0.06772258035161761 -0.5424 0.6475547570832314 0.6475545183999643 -1.1063640636133076e-06 -0.06773080354453101 -0.5425 0.6475706167577095 0.6475703989049297 -1.097070457534155e-06 -0.06773902504543043 -0.5426 0.6475864728701581 0.6475862756626336 -1.0875727004810987e-06 -0.06774724485445871 -0.5427000000000001 0.6476023254231223 0.6476021486716192 -1.077872633370447e-06 -0.06775546297175872 -0.5428000000000001 0.6476181744191291 0.6476180179304492 -1.0679721362816252e-06 -0.06776367939747352 -0.5428999999999999 0.6476340198606862 0.6476338834377043 -1.0578731284294207e-06 -0.06777189413174615 -0.543 0.6476498617502837 0.6476497451919848 -1.0475775671647813e-06 -0.06778010717471995 -0.5431 0.6476657000903914 0.6476656031919099 -1.0370874484744164e-06 -0.06778831852653812 -0.5432 0.6476815348834596 0.647681457436119 -1.0264048058428177e-06 -0.06779652818734412 -0.5433000000000001 0.6476973661319186 0.6476973079232716 -1.0155317100579708e-06 -0.06780473615728143 -0.5434 0.6477131938381784 0.6477131546520479 -1.004470269017066e-06 -0.06781294243649362 -0.5435 0.647729018004628 0.6477289976211489 -9.932226272824085e-07 -0.06782114702512447 -0.5436 0.6477448386336355 0.6477448368292972 -9.817909654707968e-07 -0.06782934992331775 -0.5437000000000001 0.6477606557275468 0.6477606722752365 -9.701775000314772e-07 -0.06783755113121732 -0.5438000000000001 0.6477764692886869 0.647776503957733 -9.583844825244991e-07 -0.06784575064896718 -0.5438999999999999 0.6477922793193578 0.6477923318755752 -9.464141996762265e-07 -0.06785394847671143 -0.544 0.6478080858218391 0.6478081560275738 -9.342689724356479e-07 -0.06786214461459421 -0.5441 0.6478238887983881 0.6478239764125633 -9.219511559188653e-07 -0.06787033906275981 -0.5442 0.6478396882512384 0.647839793029401 -9.094631385764274e-07 -0.06787853182135266 -0.5443000000000001 0.6478554841825998 0.6478556058769681 -8.968073422488398e-07 -0.06788672289051716 -0.5444 0.6478712765946585 0.64787141495417 -8.839862210840987e-07 -0.0678949122703979 -0.5445 0.6478870654895766 0.6478872202599361 -8.710022616209567e-07 -0.06790309996113955 -0.5446 0.6479028508694915 0.6479030217932207 -8.578579819285004e-07 -0.06791128596288686 -0.5447000000000001 0.647918632736516 0.6479188195530028 -8.445559313008388e-07 -0.0679194702757847 -0.5448000000000001 0.6479344110927374 0.6479346135382873 -8.3109868959097e-07 -0.067927652899978 -0.5448999999999999 0.6479501859402178 0.6479504037481039 -8.174888670720026e-07 -0.06793583383561183 -0.545 0.6479659572809937 0.6479661901815087 -8.037291035073446e-07 -0.06794401308283134 -0.5451 0.6479817251170753 0.6479819728375835 -7.898220680396806e-07 -0.0679521906417817 -0.5452 0.6479974894504467 0.6479977517154372 -7.757704582334046e-07 -0.06796036651260834 -0.5453000000000001 0.648013250283065 0.6480135268142048 -7.615769999774757e-07 -0.06796854069545664 -0.5454 0.6480290076168612 0.6480292981330488 -7.472444467082617e-07 -0.06797671319047215 -0.5455 0.6480447614537382 0.6480450656711585 -7.327755789099388e-07 -0.06798488399780045 -0.5456 0.6480605117955722 0.6480608294277513 -7.181732036842803e-07 -0.06799305311758728 -0.5457000000000001 0.6480762586442118 0.648076589402072 -7.034401540845225e-07 -0.06800122054997848 -0.5458000000000001 0.6480920020014769 0.6480923455933936 -6.885792886157649e-07 -0.06800938629511992 -0.5458999999999999 0.6481077418691601 0.6481080980010174 -6.735934907492469e-07 -0.06801755035315764 -0.546 0.648123478249025 0.6481238466242732 -6.584856682423368e-07 -0.06802571272423773 -0.5461 0.6481392111428068 0.6481395914625196 -6.432587526528089e-07 -0.06803387340850635 -0.5462 0.648154940552212 0.6481553325151445 -6.279156987420986e-07 -0.06804203240610984 -0.5463000000000001 0.6481706664789175 0.6481710697815646 -6.12459483878558e-07 -0.06805018971719456 -0.5464 0.6481863889245714 0.648186803261226 -5.968931075794881e-07 -0.06805834534190698 -0.5465 0.6482021078907914 0.6482025329536052 -5.812195908172502e-07 -0.06806649928039368 -0.5466 0.6482178233791668 0.6482182588582083 -5.654419754225204e-07 -0.06807465153280139 -0.5467000000000001 0.6482335353912556 0.6482339809745711 -5.495633236124453e-07 -0.06808280209927682 -0.5468000000000001 0.6482492439285863 0.6482496993022598 -5.335867172828745e-07 -0.0680909509799668 -0.5468999999999999 0.6482649489926567 0.6482654138408717 -5.175152574948827e-07 -0.06809909817501832 -0.547 0.6482806505849344 0.6482811245900342 -5.013520637392466e-07 -0.0681072436845784 -0.5471 0.6482963487068565 0.648296831549406 -4.851002735062337e-07 -0.06811538750879428 -0.5472 0.6483120433598283 0.6483125347186762 -4.6876304155007986e-07 -0.06812352964781314 -0.5473000000000001 0.6483277345452249 0.6483282340975657 -4.523435394171438e-07 -0.06813167010178228 -0.5474 0.6483434222643896 0.6483439296858267 -4.3584495461324035e-07 -0.06813980887084917 -0.5475 0.6483591065186347 0.6483596214832423 -4.192704901873068e-07 -0.06814794595516133 -0.5476 0.6483747873092407 0.6483753094896284 -4.0262336398894094e-07 -0.06815608135486638 -0.5477000000000001 0.6483904646374564 0.6483909937048316 -3.859068081410455e-07 -0.06816421507011199 -0.5478000000000001 0.6484061385044991 0.6484066741287313 -3.6912406834593847e-07 -0.06817234710104601 -0.5478999999999999 0.6484218089115538 0.6484223507612386 -3.5227840329554727e-07 -0.06818047744781636 -0.548 0.6484374758597733 0.6484380236022971 -3.353730839567026e-07 -0.068188606110571 -0.5481 0.6484531393502784 0.648453692651882 -3.1841139302296595e-07 -0.06819673308945799 -0.5482 0.6484687993841579 0.648469357910002 -3.0139662428319003e-07 -0.06820485838462557 -0.5483000000000001 0.6484844559624678 0.6484850193766977 -2.843320819068129e-07 -0.06821298199622203 -0.5484 0.6485001090862313 0.6485006770520425 -2.672210798401742e-07 -0.06822110392439566 -0.5485 0.6485157587564396 0.6485163309361428 -2.500669412167089e-07 -0.068229224169295 -0.5486 0.6485314049740507 0.6485319810291373 -2.32872997621425e-07 -0.06823734273106857 -0.5487000000000001 0.6485470477399898 0.6485476273311982 -2.156425885323221e-07 -0.06824545960986504 -0.5488000000000001 0.6485626870551497 0.6485632698425305 -1.9837906057446064e-07 -0.06825357480583316 -0.5488999999999999 0.64857832292039 0.6485789085633722 -1.8108576695791134e-07 -0.06826168831912176 -0.549 0.648593955336537 0.6485945434939945 -1.6376606676304917e-07 -0.06826980014987975 -0.5491 0.6486095843043842 0.6486101746347018 -1.4642332433686955e-07 -0.06827791029825618 -0.5492 0.6486252098246919 0.6486258019858318 -1.2906090861644626e-07 -0.06828601876440016 -0.5493000000000001 0.6486408318981877 0.6486414255477553 -1.116821924680017e-07 -0.06829412554846094 -0.5494 0.6486564505255653 0.6486570453208768 -9.42905520589371e-08 -0.06830223065058778 -0.5495 0.6486720657074854 0.6486726613056338 -7.688936615179998e-08 -0.06831033407093011 -0.5496 0.6486876774445758 0.6486882735024974 -5.948201549886567e-08 -0.06831843580963744 -0.5497000000000001 0.6487032857374304 0.6487038819119718 -4.2071882157788953e-08 -0.06832653586685929 -0.5498000000000001 0.6487188905866105 0.6487194865345951 -2.4662348845636353e-08 -0.06833463424274538 -0.5498999999999999 0.6487344919926438 0.6487350873709387 -7.256798272535503e-09 -0.06834273093744553 -0.55 0.6487500899560243 0.6487506844216067 1.0141387514484013e-08 -0.0683508259511095 -0.5501 0.6487656844772134 0.6487662776872375 2.7528827783313004e-08 -0.0683589192838873 -0.5502 0.6487812755566392 0.6487818671685027 4.490214378441437e-08 -0.06836701093592905 -0.5503000000000001 0.6487968631946961 0.6487974528661069 6.225795939895917e-08 -0.06837510090738479 -0.5504 0.6488124473917454 0.6488130347807886 7.959290179715417e-08 -0.06838318919840482 -0.5505 0.6488280281481156 0.648828612913319 9.690360209743676e-08 -0.06839127580913945 -0.5506 0.6488436054641016 0.6488441872645029 1.1418669602913933e-07 -0.0683993607397391 -0.5507000000000001 0.6488591793399653 0.6488597578351785 1.3143882456739808e-07 -0.06840744399035428 -0.5508000000000001 0.648874749775936 0.6488753246262167 1.4865663460969514e-07 -0.06841552556113562 -0.5509 0.6488903167722095 0.6488908876385219 1.6583677960035903e-07 -0.0684236054522338 -0.551 0.6489058803289491 0.6489064468730316 1.8297592021404574e-07 -0.06843168366379966 -0.5511 0.6489214404462845 0.6489220023307156 2.0007072501493361e-07 -0.06843976019598401 -0.5512 0.6489369971243136 0.6489375540125777 2.17117871036121e-07 -0.06844783504893787 -0.5513000000000001 0.6489525503631008 0.6489531019196533 2.3411404450474071e-07 -0.06845590822281228 -0.5514 0.6489681001626787 0.6489686460530114 2.510559414387048e-07 -0.0684639797177584 -0.5515 0.6489836465230467 0.6489841864137533 2.6794026831977735e-07 -0.06847204953392753 -0.5516 0.6489991894441725 0.6489997230030129 2.847637427250138e-07 -0.06848011767147098 -0.5517000000000001 0.6490147289259909 0.6490152558219563 3.015230939720781e-07 -0.06848818413054021 -0.5518000000000001 0.6490302649684047 0.6490307848717818 3.182150637298653e-07 -0.0684962489112867 -0.5519 0.649045797571285 0.6490463101537205 3.3483640666381875e-07 -0.06850431201386213 -0.552 0.6490613267344707 0.6490618316690351 3.513838911367584e-07 -0.06851237343841819 -0.5521 0.649076852457769 0.6490773494190198 3.6785429972929773e-07 -0.06852043318510669 -0.5522 0.6490923747409556 0.6490928634050013 3.8424442991291663e-07 -0.06852849125407953 -0.5523 0.6491078935837744 0.6491083736283374 4.005510947091562e-07 -0.06853654764548865 -0.5524 0.6491234089859383 0.6491238800904173 4.167711232655469e-07 -0.06854460235948621 -0.5525 0.6491389209471288 0.649139382792662 4.329013615356203e-07 -0.06855265539622434 -0.5526 0.6491544294669968 0.6491548817365232 4.4893867275075383e-07 -0.06856070675585527 -0.5527000000000001 0.649169934545162 0.6491703769234836 4.648799382667157e-07 -0.06856875643853137 -0.5528000000000001 0.6491854361812135 0.6491858683550568 4.807220579244875e-07 -0.06857680444440514 -0.5529 0.6492009343747102 0.649201356032787 4.964619508274204e-07 -0.0685848507736291 -0.553 0.6492164291251803 0.6492168399582482 5.120965558685908e-07 -0.0685928954263558 -0.5531 0.6492319204321222 0.6492323201330457 5.276228323553012e-07 -0.06860093840273802 -0.5532 0.6492474082950046 0.6492477965588137 5.430377605503134e-07 -0.06860897970292859 -0.5533 0.6492628927132665 0.6492632692372169 5.583383423241051e-07 -0.06861701932708038 -0.5534 0.649278373686317 0.6492787381699493 5.735216017238587e-07 -0.06862505727534636 -0.5535 0.6492938512135364 0.6492942033587343 5.885845856118399e-07 -0.06863309354787965 -0.5536 0.6493093252942759 0.6493096648053243 6.035243640817312e-07 -0.0686411281448334 -0.5537000000000001 0.649324795927858 0.6493251225115008 6.183380311941544e-07 -0.06864916106636092 -0.5538000000000001 0.6493402631135765 0.6493405764790737 6.330227054068827e-07 -0.0686571923126155 -0.5539 0.6493557268506971 0.6493560267098815 6.475755303519959e-07 -0.06866522188375061 -0.554 0.6493711871384574 0.6493714732057906 6.619936750856814e-07 -0.06867324977991977 -0.5541 0.6493866439760672 0.6493869159686959 6.762743348931455e-07 -0.06868127600127664 -0.5542 0.6494020973627086 0.6494023550005195 6.904147317882137e-07 -0.06868930054797492 -0.5543 0.6494175472975369 0.649417790303211 7.044121150129312e-07 -0.06869732342016847 -0.5544 0.6494329937796799 0.6494332218787471 7.182637615371634e-07 -0.06870534461801113 -0.5545 0.6494484368082389 0.6494486497291309 7.319669766275849e-07 -0.06871336414165687 -0.5546 0.649463876382289 0.6494640738563927 7.455190943750356e-07 -0.0687213819912598 -0.5547000000000001 0.6494793125008789 0.6494794942625889 7.589174783884101e-07 -0.0687293981669741 -0.5548000000000001 0.6494947451630312 0.6494949109498016 7.721595220444577e-07 -0.06873741266895399 -0.5549 0.6495101743677438 0.6495103239201391 7.852426489873832e-07 -0.0687454254973539 -0.555 0.649525600113988 0.6495257331757345 7.981643138921246e-07 -0.06875343665232815 -0.5551 0.6495410224007114 0.6495411387187462 8.109220028529318e-07 -0.06876144613403133 -0.5552 0.6495564412268364 0.6495565405513575 8.235132338274553e-07 -0.06876945394261808 -0.5553 0.649571856591261 0.6495719386757762 8.359355570808358e-07 -0.06877746007824306 -0.5554 0.6495872684928596 0.6495873330942341 8.481865556575485e-07 -0.06878546454106112 -0.5555 0.6496026769304825 0.6496027238089865 8.602638461030487e-07 -0.06879346733122711 -0.5556 0.6496180819029568 0.6496181108223128 8.721650785747936e-07 -0.06880146844889606 -0.5557000000000001 0.6496334834090866 0.649633494136515 8.838879375361319e-07 -0.06880946789422299 -0.5558000000000001 0.6496488814476531 0.6496488737539181 8.954301423391708e-07 -0.06881746566736303 -0.5559 0.6496642760174157 0.6496642496768694 9.067894472525317e-07 -0.06882546176847147 -0.556 0.6496796671171116 0.6496796219077386 9.179636421274839e-07 -0.06883345619770363 -0.5561 0.6496950547454556 0.649694990448917 9.289505531195896e-07 -0.06884144895521492 -0.5562 0.6497104389011428 0.6497103553028174 9.397480424111482e-07 -0.06884944004116093 -0.5563 0.649725819582846 0.6497257164718733 9.503540093769303e-07 -0.0688574294556972 -0.5564 0.6497411967892179 0.6497410739585392 9.607663905564223e-07 -0.0688654171989794 -0.5565 0.6497565705188911 0.6497564277652899 9.709831602922048e-07 -0.06887340327116337 -0.5566 0.6497719407704787 0.6497717778946196 9.810023307854632e-07 -0.06888138767240495 -0.5567000000000001 0.6497873075425734 0.6497871243490431 9.90821953095189e-07 -0.06888937040286011 -0.5568000000000001 0.6498026708337499 0.6498024671310932 1.0004401166108234e-06 -0.06889735146268487 -0.5569 0.6498180306425638 0.6498178062433223 1.00985495035677e-06 -0.06890533085203542 -0.557 0.6498333869675521 0.6498331416883009 1.0190646229091271e-06 -0.06891330857106794 -0.5571 0.6498487398072347 0.6498484734686174 1.0280673427287557e-06 -0.06892128461993875 -0.5572 0.6498640891601133 0.6498638015868781 1.0368613586331232e-06 -0.0689292589988043 -0.5573 0.6498794350246727 0.649879126045706 1.0454449601016158e-06 -0.068937231707821 -0.5574 0.6498947773993813 0.6498944468477414 1.053816477580849e-06 -0.06894520274714551 -0.5575 0.649910116282691 0.6499097639956408 1.0619742827899792e-06 -0.06895317211693446 -0.5576 0.6499254516730377 0.6499250774920766 1.0699167891925487e-06 -0.06896113981734457 -0.5577000000000001 0.6499407835688422 0.6499403873397374 1.0776424521907746e-06 -0.06896910584853282 -0.5578000000000001 0.64995611196851 0.6499556935413259 1.0851497695418821e-06 -0.06897707021065602 -0.5579 0.6499714368704319 0.6499709960995602 1.0924372814136163e-06 -0.06898503290387124 -0.558 0.6499867582729846 0.6499862950171726 1.0995035709115974e-06 -0.06899299392833555 -0.5581 0.6500020761745311 0.6500015902969097 1.1063472641348326e-06 -0.06900095328420622 -0.5582 0.650017390573421 0.6500168819415308 1.1129670308140938e-06 -0.0690089109716405 -0.5583 0.6500327014679907 0.6500321699538084 1.1193615841176285e-06 -0.06901686699079573 -0.5584 0.650048008856565 0.6500474543365284 1.125529681400561e-06 -0.06902482134182945 -0.5585 0.6500633127374551 0.6500627350924879 1.1314701238440694e-06 -0.06903277402489914 -0.5586 0.6500786131089623 0.6500780122244963 1.1371817572602971e-06 -0.0690407250401625 -0.5587000000000001 0.6500939099693757 0.6500932857353743 1.1426634719535755e-06 -0.06904867438777722 -0.5588000000000001 0.6501092033169735 0.6501085556279527 1.1479142034420686e-06 -0.06905662206790111 -0.5589 0.6501244931500243 0.650123821905074 1.1529329317916392e-06 -0.0690645680806921 -0.559 0.6501397794667865 0.6501390845695894 1.1577186826150498e-06 -0.06907251242630814 -0.5591 0.6501550622655087 0.6501543436243604 1.1622705267944067e-06 -0.06908045510490733 -0.5592 0.6501703415444318 0.6501695990722576 1.166587581258316e-06 -0.06908839611664787 -0.5593 0.6501856173017866 0.6501848509161599 1.170669008260239e-06 -0.06909633546168799 -0.5594 0.6502008895357968 0.650200099158954 1.174514016460959e-06 -0.06910427314018597 -0.5595 0.6502161582446786 0.6502153438035351 1.1781218602346932e-06 -0.06911220915230032 -0.5596 0.6502314234266404 0.6502305848528052 1.181491840585025e-06 -0.0691201434981895 -0.5597000000000001 0.6502466850798847 0.650245822309673 1.1846233049228605e-06 -0.06912807617801214 -0.5598000000000001 0.6502619432026071 0.6502610561770539 1.1875156470941839e-06 -0.06913600719192692 -0.5599 0.650277197792998 0.6502762864578691 1.1901683076298575e-06 -0.06914393654009264 -0.56 0.6502924488492419 0.6502915131550449 1.1925807739121552e-06 -0.0691518642226681 -0.5601 0.6503076963695191 0.6503067362715127 1.1947525801470071e-06 -0.06915979023981232 -0.5602 0.6503229403520052 0.6503219558102089 1.196683307835844e-06 -0.06916771459168435 -0.5603 0.650338180794872 0.6503371717740731 1.1983725851372196e-06 -0.06917563727844328 -0.5604 0.6503534176962874 0.6503523841660486 1.1998200875051879e-06 -0.06918355830024829 -0.5605 0.650368651054417 0.6503675929890821 1.201025537772571e-06 -0.06919147765725873 -0.5606 0.6503838808674235 0.650382798246123 1.2019887058734025e-06 -0.06919939534963393 -0.5607000000000001 0.6503991071334676 0.6503979999401224 1.2027094092037505e-06 -0.0692073113775334 -0.5608000000000001 0.6504143298507087 0.6504131980740335 1.2031875124829394e-06 -0.06921522574111669 -0.5609 0.6504295490173049 0.6504283926508106 1.2034229277535502e-06 -0.06922313844054344 -0.561 0.6504447646314134 0.6504435836734086 1.2034156144646868e-06 -0.06923104947597339 -0.5611 0.6504599766911918 0.6504587711447827 1.20316557963851e-06 -0.06923895884756633 -0.5612 0.6504751851947974 0.6504739550678882 1.2026728776759477e-06 -0.0692468665554822 -0.5613 0.6504903901403887 0.6504891354456797 1.2019376102456736e-06 -0.06925477259988101 -0.5614 0.6505055915261253 0.6505043122811097 1.2009599265339066e-06 -0.06926267698092274 -0.5615 0.6505207893501685 0.6505194855771308 1.1997400232166555e-06 -0.06927057969876764 -0.5616 0.6505359836106817 0.6505346553366922 1.1982781443486967e-06 -0.06927848075357593 -0.5617000000000001 0.6505511743058314 0.6505498215627412 1.1965745809472406e-06 -0.06928638014550799 -0.5618000000000001 0.6505663614337863 0.6505649842582215 1.1946296714915317e-06 -0.06929427787472416 -0.5619 0.6505815449927195 0.6505801434260741 1.1924438018395822e-06 -0.06930217394138492 -0.562 0.6505967249808078 0.6505952990692354 1.1900174044787715e-06 -0.06931006834565097 -0.5621 0.6506119013962328 0.6506104511906379 1.1873509594140241e-06 -0.06931796108768291 -0.5622 0.6506270742371807 0.6506255997932089 1.1844449931963652e-06 -0.06932585216764156 -0.5623 0.6506422435018433 0.6506407448798707 1.1813000796168094e-06 -0.06933374158568775 -0.5624 0.6506574091884185 0.6506558864535394 1.1779168389569605e-06 -0.06934162934198239 -0.5625 0.6506725712951101 0.650671024517125 1.1742959379890117e-06 -0.0693495154366865 -0.5626 0.6506877298201291 0.6506861590735309 1.1704380902810563e-06 -0.06935739986996121 -0.5627000000000001 0.6507028847616938 0.650701290125653 1.1663440554476878e-06 -0.06936528264196769 -0.5628000000000001 0.65071803611803 0.6507164176763802 1.1620146396218445e-06 -0.06937316375286724 -0.5629 0.6507331838873719 0.6507315417285928 1.1574506947331642e-06 -0.06938104320282122 -0.563 0.6507483280679625 0.6507466622851628 1.1526531185912514e-06 -0.06938892099199111 -0.5631 0.650763468658053 0.6507617793489527 1.1476228550522105e-06 -0.06939679712053835 -0.5632 0.6507786056559056 0.6507768929228164 1.142360893019445e-06 -0.06940467158862466 -0.5633 0.6507937390597914 0.6507920030095967 1.1368682671097918e-06 -0.06941254439641165 -0.5634 0.6508088688679925 0.6508071096121271 1.131146056959631e-06 -0.06942041554406113 -0.5635 0.6508239950788017 0.6508222127332302 1.1251953870305975e-06 -0.06942828503173504 -0.5636 0.650839117690523 0.6508373123757167 1.1190174267206032e-06 -0.06943615285959528 -0.5637000000000001 0.6508542367014727 0.6508524085423865 1.112613389697703e-06 -0.06944401902780391 -0.5638000000000001 0.650869352109979 0.6508675012360265 1.1059845340666286e-06 -0.06945188353652307 -0.5639 0.6508844639143823 0.6508825904594118 1.0991321618414318e-06 -0.06945974638591493 -0.564 0.6508995721130371 0.6508976762153036 1.0920576188622189e-06 -0.06946760757614179 -0.5641 0.6509146767043106 0.6509127585064509 1.084762294378816e-06 -0.0694754671073661 -0.5642 0.6509297776865842 0.6509278373355878 1.0772476208842363e-06 -0.06948332497975025 -0.5643 0.650944875058254 0.6509429127054347 1.0695150739759018e-06 -0.06949118119345687 -0.5644 0.6509599688177304 0.6509579846186968 1.0615661717172653e-06 -0.0694990357486485 -0.5645 0.6509750589634394 0.6509730530780646 1.0534024746933213e-06 -0.06950688864548792 -0.5646 0.6509901454938227 0.6509881180862128 1.045025585372228e-06 -0.06951473988413787 -0.5647000000000001 0.651005228407338 0.6510031796458007 1.0364371482718404e-06 -0.06952258946476135 -0.5648000000000001 0.651020307702459 0.6510182377594701 1.0276388492103106e-06 -0.06953043738752124 -0.5649 0.651035383377677 0.6510332924298471 1.0186324150285309e-06 -0.06953828365258063 -0.565 0.6510504554315002 0.65104834365954 1.0094196132570676e-06 -0.06954612826010269 -0.5651 0.6510655238624548 0.6510633914511399 1.0000022521994278e-06 -0.06955397121025059 -0.5652 0.6510805886690847 0.6510784358072194 9.903821800716361e-07 -0.06956181250318766 -0.5653 0.6510956498499525 0.6510934767303331 9.805612847801903e-07 -0.06956965213907729 -0.5654 0.6511107074036397 0.651108514223017 9.705414935057277e-07 -0.069577490118083 -0.5655 0.6511257613287471 0.6511235482877872 9.60324772647514e-07 -0.06958532644036826 -0.5656 0.651140811623895 0.6511385789271409 9.499131270462868e-07 -0.06959316110609678 -0.5657000000000001 0.6511558582877239 0.651153606143555 9.393085997067008e-07 -0.06960099411543226 -0.5658000000000001 0.6511709013188948 0.6511686299394867 9.285132714920152e-07 -0.06960882546853853 -0.5659 0.6511859407160893 0.6511836503173717 9.175292607077612e-07 -0.0696166551655795 -0.566 0.65120097647801 0.6511986672796249 9.063587226298964e-07 -0.06962448320671911 -0.5661 0.6512160086033815 0.6512136808286402 8.950038491994938e-07 -0.06963230959212145 -0.5662 0.65123103709095 0.6512286909667891 8.834668683010971e-07 -0.06964013432195067 -0.5663 0.6512460619394839 0.6512436976964214 8.717500436794534e-07 -0.06964795739637096 -0.5664 0.6512610831477742 0.6512587010198643 8.598556743844021e-07 -0.06965577881554667 -0.5665 0.651276100714635 0.651273700939422 8.477860941602522e-07 -0.06966359857964219 -0.5666 0.6512911146389038 0.6512886974573759 8.355436711404707e-07 -0.06967141668882201 -0.5667000000000001 0.651306124919441 0.6513036905759834 8.231308073758381e-07 -0.06967923314325064 -0.5668000000000001 0.6513211315551317 0.651318680297478 8.105499384181147e-07 -0.06968704794309274 -0.5669 0.6513361345448854 0.6513336666240697 7.978035326816624e-07 -0.06969486108851308 -0.567 0.6513511338876357 0.6513486495579436 7.84894091138133e-07 -0.06970267257967648 -0.5671 0.6513661295823409 0.6513636291012596 7.71824146650335e-07 -0.06971048241674778 -0.5672 0.6513811216279854 0.6513786052561528 7.585962638056998e-07 -0.06971829059989197 -0.5673 0.6513961100235784 0.651393578024733 7.452130379170807e-07 -0.0697260971292741 -0.5674 0.6514110947681558 0.6514085474090839 7.316770949256091e-07 -0.06973390200505936 -0.5675 0.6514260758607787 0.6514235134112636 7.179910906929265e-07 -0.06974170522741294 -0.5676 0.6514410533005353 0.6514384760333032 7.04157710570974e-07 -0.06974950679650012 -0.5677000000000001 0.65145602708654 0.6514534352772076 6.90179668833002e-07 -0.06975730671248634 -0.5678000000000001 0.6514709972179352 0.6514683911449546 6.760597081878483e-07 -0.06976510497553705 -0.5679 0.6514859636938897 0.6514833436384949 6.618005991415599e-07 -0.06977290158581782 -0.568 0.6515009265136003 0.6514982927597515 6.474051395810587e-07 -0.06978069654349427 -0.5681 0.6515158856762913 0.6515132385106202 6.328761541773975e-07 -0.06978848984873214 -0.5682 0.6515308411812154 0.6515281808929678 6.182164937473811e-07 -0.06979628150169719 -0.5683 0.6515457930276539 0.6515431199086338 6.034290348094773e-07 -0.06980407150255535 -0.5684 0.6515607412149164 0.6515580555594286 5.885166790564611e-07 -0.06981185985147255 -0.5685 0.6515756857423413 0.6515729878471336 5.734823526337696e-07 -0.06981964654861482 -0.5686 0.6515906266092968 0.6515879167735021 5.583290056954127e-07 -0.0698274315941484 -0.5687000000000001 0.6516055638151792 0.6516028423402573 5.430596117517172e-07 -0.06983521498823939 -0.5688000000000001 0.6516204973594157 0.6516177645490935 5.276771671836045e-07 -0.06984299673105412 -0.5689 0.6516354272414626 0.6516326834016745 5.121846904376781e-07 -0.06985077682275896 -0.569 0.6516503534608062 0.651647598899635 4.965852217903022e-07 -0.0698585552635204 -0.5691 0.6516652760169633 0.6516625110445788 4.808818224455447e-07 -0.06986633205350488 -0.5692 0.6516801949094815 0.6516774198380803 4.650775739939439e-07 -0.06987410719287916 -0.5693 0.6516951101379379 0.6516923252816823 4.4917557792678586e-07 -0.06988188068180985 -0.5694 0.6517100217019418 0.6517072273768978 4.3317895491445935e-07 -0.0698896525204638 -0.5695 0.6517249296011324 0.6517221261252082 4.170908443068555e-07 -0.0698974227090078 -0.5696 0.6517398338351807 0.6517370215280637 4.0091440338396733e-07 -0.06990519124760881 -0.5697000000000001 0.6517547344037892 0.651751913586884 3.846528068701671e-07 -0.0699129581364339 -0.5698000000000001 0.6517696313066916 0.6517668023030567 3.683092461570503e-07 -0.06992072337565018 -0.5699 0.6517845245436534 0.6517816876779378 3.518869287899573e-07 -0.0699284869654248 -0.57 0.6517994141144725 0.6517965697128517 3.3538907786428984e-07 -0.06993624890592508 -0.5701 0.651814300018978 0.6518114484090908 3.1881893130386585e-07 -0.06994400919731834 -0.5702 0.6518291822570316 0.6518263237679153 3.0217974130580805e-07 -0.069951767839772 -0.5703 0.6518440608285274 0.6518411957905534 2.854747736605323e-07 -0.06995952483345362 -0.5704 0.6518589357333919 0.6518560644782007 2.687073070370416e-07 -0.06996728017853077 -0.5705 0.6518738069715839 0.6518709298320204 2.518806325041423e-07 -0.06997503387517112 -0.5706 0.6518886745430954 0.6518857918531435 2.349980527602269e-07 -0.06998278592354248 -0.5707000000000001 0.6519035384479508 0.6519006505426675 2.180628815365293e-07 -0.06999053632381262 -0.5708000000000001 0.6519183986862075 0.6519155059016576 2.0107844293099086e-07 -0.06999828507614947 -0.5709 0.6519332552579563 0.6519303579311462 1.8404807076294327e-07 -0.07000603218072109 -0.571 0.6519481081633205 0.6519452066321321 1.6697510793473036e-07 -0.07001377763769552 -0.5711 0.651962957402457 0.6519600520055814 1.49862905717002e-07 -0.0700215214472409 -0.5712 0.6519778029755559 0.651974894052427 1.327148231693165e-07 -0.0700292636095255 -0.5713 0.6519926448828404 0.6519897327735686 1.1553422642196498e-07 -0.07003700412471765 -0.5714 0.6520074831245676 0.6520045681698723 9.832448803065441e-08 -0.07004474299298571 -0.5715 0.6520223177010278 0.652019400242171 8.108898635200701e-08 -0.07005248021449821 -0.5716 0.6520371486125449 0.652034228991264 6.383110481497645e-08 -0.07006021578942369 -0.5717000000000001 0.6520519758594767 0.652049054417917 4.655423129981684e-08 -0.0700679497179308 -0.5718000000000001 0.652066799442214 0.6520638765228628 2.9261757471948924e-08 -0.07007568200018827 -0.5719 0.6520816193611818 0.6520786953067998 1.195707810194846e-08 -0.0700834126363649 -0.572 0.6520964356168386 0.6520935107703936 -5.356409608393842e-09 -0.0700911416266296 -0.5721 0.6521112482096765 0.6521083229142755 -2.2675306665317918e-08 -0.07009886897115129 -0.5722 0.6521260571402215 0.6521231317390431 -3.999621297481534e-08 -0.07010659467009905 -0.5723 0.6521408624090335 0.652137937245261 -5.7315728001824245e-08 -0.07011431872364199 -0.5724 0.6521556640167057 0.6521527394334597 -7.463045143809785e-08 -0.0701220411319493 -0.5725 0.6521704619638651 0.652167538304136 -9.193698387310878e-08 -0.07012976189519024 -0.5726 0.652185256251173 0.6521823338577531 -1.0923192745627974e-07 -0.07013748101353423 -0.5727000000000001 0.6522000468793239 0.6521971260947411 -1.265118865778625e-07 -0.07014519848715069 -0.5728000000000001 0.6522148338490464 0.6522119150154958 -1.4377346852466333e-07 -0.07015291431620915 -0.5729 0.6522296171611024 0.6522267006203799 -1.6101328415007998e-07 -0.07016062850087922 -0.573 0.6522443968162872 0.6522414829097218 -1.7822794854197022e-07 -0.07016834104133055 -0.5731 0.6522591728154304 0.6522562618838175 -1.9541408167664254e-07 -0.07017605193773291 -0.5732 0.6522739451593946 0.6522710375429289 -2.1256830911101088e-07 -0.07018376119025617 -0.5733 0.652288713849076 0.6522858098872847 -2.2968726261576866e-07 -0.07019146879907022 -0.5734 0.6523034788854043 0.6523005789170799 -2.467675808415226e-07 -0.07019917476434508 -0.5735 0.6523182402693423 0.6523153446324771 -2.6380591004043774e-07 -0.07020687908625081 -0.5736 0.6523329980018863 0.6523301070336047 -2.8079890460747103e-07 -0.07021458176495757 -0.5737000000000001 0.6523477520840655 0.6523448661205588 -2.977432278505887e-07 -0.07022228280063557 -0.5738000000000001 0.6523625025169427 0.6523596218934021 -3.1463555258404163e-07 -0.07022998219345519 -0.5739 0.6523772493016133 0.6523743743521648 -3.3147256178756024e-07 -0.07023767994358679 -0.574 0.6523919924392054 0.6523891234968441 -3.482509493210606e-07 -0.07024537605120083 -0.5741 0.6524067319308805 0.6524038693274039 -3.649674205283282e-07 -0.07025307051646792 -0.5742 0.6524214677778322 0.6524186118437764 -3.816186928337628e-07 -0.07026076333955861 -0.5743 0.6524361999812869 0.6524333510458609 -3.9820149647096237e-07 -0.07026845452064368 -0.5744 0.6524509285425031 0.6524480869335245 -4.147125750794678e-07 -0.07027614405989382 -0.5745 0.6524656534627722 0.6524628195066025 -4.3114868639865245e-07 -0.07028383195748003 -0.5746 0.6524803747434169 0.6524775487648973 -4.475066028228336e-07 -0.07029151821357314 -0.5747000000000001 0.6524950923857928 0.6524922747081802 -4.6378311215067303e-07 -0.07029920282834426 -0.5748000000000001 0.6525098063912869 0.6525069973361899 -4.799750180778384e-07 -0.07030688580196442 -0.5749 0.6525245167613174 0.6525217166486345 -4.96079140932526e-07 -0.07031456713460486 -0.575 0.6525392234973348 0.65253643264519 -5.120923182583281e-07 -0.07032224682643683 -0.5751000000000001 0.6525539266008202 0.6525511453255013 -5.280114055150609e-07 -0.07032992487763157 -0.5752 0.6525686260732869 0.6525658546891825 -5.438332765644871e-07 -0.07033760128836063 -0.5753 0.652583321916278 0.6525805607358164 -5.595548243086945e-07 -0.07034527605879545 -0.5754 0.6525980141313679 0.6525952634649556 -5.75172961453374e-07 -0.0703529491891076 -0.5755 0.6526127027201618 0.6526099628761217 -5.906846209935424e-07 -0.07036062067946872 -0.5756 0.652627387684295 0.6526246589688063 -6.060867567547756e-07 -0.07036829053005055 -0.5757000000000001 0.6526420690254329 0.6526393517424709 -6.213763441703657e-07 -0.0703759587410249 -0.5758000000000001 0.6526567467452709 0.6526540411965472 -6.365503807254091e-07 -0.07038362531256363 -0.5759 0.6526714208455344 0.6526687273304372 -6.516058866368191e-07 -0.07039129024483877 -0.576 0.6526860913279782 0.6526834101435132 -6.665399053390475e-07 -0.07039895353802231 -0.5761000000000001 0.6527007581943859 0.6526980896351187 -6.813495042612416e-07 -0.07040661519228635 -0.5762 0.6527154214465706 0.6527127658045679 -6.96031775201944e-07 -0.07041427520780309 -0.5763 0.6527300810863742 0.6527274386511466 -7.105838350091043e-07 -0.07042193358474483 -0.5764 0.652744737115667 0.652742108174112 -7.250028260380459e-07 -0.0704295903232839 -0.5765 0.6527593895363478 0.6527567743726935 -7.392859168869892e-07 -0.07043724542359277 -0.5766 0.652774038350343 0.6527714372460918 -7.534303029382849e-07 -0.07044489888584388 -0.5767 0.6527886835596071 0.6527860967934803 -7.674332067608702e-07 -0.07045255071020982 -0.5768000000000001 0.6528033251661216 0.6528007530140054 -7.812918786931355e-07 -0.0704602008968633 -0.5769 0.6528179631718959 0.6528154059067859 -7.95003597481303e-07 -0.07046784944597699 -0.577 0.652832597578966 0.6528300554709137 -8.085656708622935e-07 -0.07047549635772375 -0.5771000000000001 0.6528472283893944 0.6528447017054544 -8.219754358135267e-07 -0.07048314163227647 -0.5772 0.6528618556052701 0.6528593446094475 -8.352302594272221e-07 -0.07049078526980809 -0.5773 0.6528764792287083 0.6528739841819062 -8.483275391601985e-07 -0.0704984272704917 -0.5774 0.6528910992618494 0.6528886204218183 -8.61264703611031e-07 -0.07050606763450039 -0.5775 0.6529057157068598 0.6529032533281458 -8.740392127559726e-07 -0.07051370636200736 -0.5776 0.6529203285659306 0.6529178828998264 -8.866485584346773e-07 -0.07052134345318592 -0.5777 0.6529349378412781 0.6529325091357726 -8.990902653494004e-07 -0.07052897890820937 -0.5778000000000001 0.6529495435351425 0.6529471320348725 -9.113618908984655e-07 -0.07053661272725117 -0.5779 0.6529641456497887 0.6529617515959902 -9.234610261199538e-07 -0.07054424491048482 -0.578 0.6529787441875051 0.6529763678179663 -9.353852957749709e-07 -0.07055187545808389 -0.5781000000000001 0.6529933391506038 0.6529909806996177 -9.471323593190917e-07 -0.07055950437022204 -0.5782 0.6530079305414195 0.6530055902397385 -9.586999108190941e-07 -0.070567131647073 -0.5783 0.6530225183623104 0.6530201964371 -9.700856798133817e-07 -0.07057475728881062 -0.5784 0.6530371026156566 0.6530347992904514 -9.81287431534028e-07 -0.07058238129560879 -0.5785 0.6530516833038605 0.6530493987985191 -9.923029676561779e-07 -0.07059000366764139 -0.5786 0.653066260429346 0.6530639949600089 -1.0031301262980463e-06 -0.07059762440508256 -0.5787 0.6530808339945589 0.653078587773605 -1.0137667826592978e-06 -0.07060524350810637 -0.5788000000000001 0.6530954040019649 0.6530931772379701 -1.0242108496039126e-06 -0.07061286097688702 -0.5789 0.6531099704540515 0.6531077633517475 -1.0344602778544765e-06 -0.07062047681159882 -0.579 0.6531245333533258 0.6531223461135595 -1.0445130564085137e-06 -0.07062809101241606 -0.5791000000000001 0.6531390927023144 0.6531369255220086 -1.054367213010332e-06 -0.07063570357951314 -0.5792 0.6531536485035643 0.6531515015756786 -1.0640208145951124e-06 -0.0706433145130646 -0.5793 0.6531682007596407 0.653166074273134 -1.073471967427686e-06 -0.07065092381324507 -0.5794 0.6531827494731277 0.6531806436129202 -1.0827188179074465e-06 -0.07065853148022909 -0.5795 0.6531972946466282 0.6531952095935651 -1.091759552429572e-06 -0.07066613751419144 -0.5796 0.6532118362827621 0.6532097722135788 -1.1005923981621812e-06 -0.07067374191530693 -0.5797 0.6532263743841673 0.6532243314714533 -1.1092156231018446e-06 -0.07068134468375036 -0.5798000000000001 0.653240908953499 0.6532388873656647 -1.1176275365731847e-06 -0.0706889458196968 -0.5799 0.653255439993428 0.6532534398946714 -1.125826489561943e-06 -0.07069654532332122 -0.58 0.653269967506643 0.6532679890569164 -1.133810875103558e-06 -0.07070414319479872 -0.5801000000000001 0.6532844914958471 0.6532825348508269 -1.14157912825541e-06 -0.07071173943430452 -0.5802 0.653299011963759 0.6532970772748142 -1.1491297270127543e-06 -0.07071933404201378 -0.5803 0.6533135289131125 0.6533116163272756 -1.1564611918646328e-06 -0.07072692701810186 -0.5804 0.6533280423466568 0.6533261520065933 -1.16357208682083e-06 -0.07073451836274425 -0.5805 0.6533425522671539 0.6533406843111357 -1.1704610192175835e-06 -0.07074210807611635 -0.5806 0.65335705867738 0.653355213239257 -1.1771266401339187e-06 -0.0707496961583937 -0.5807 0.6533715615801252 0.6533697387892994 -1.1835676448357368e-06 -0.07075728260975199 -0.5808000000000001 0.6533860609781914 0.6533842609595915 -1.1897827724705046e-06 -0.07076486743036689 -0.5809 0.6534005568743934 0.6533987797484497 -1.1957708070386985e-06 -0.07077245062041419 -0.581 0.6534150492715578 0.6534132951541789 -1.20153057736605e-06 -0.07078003218006976 -0.5811000000000001 0.6534295381725226 0.6534278071750723 -1.2070609570202784e-06 -0.0707876121095095 -0.5812 0.653444023580137 0.6534423158094125 -1.2123608649494688e-06 -0.07079519040890944 -0.5813 0.6534585054972606 0.6534568210554708 -1.2174292655098284e-06 -0.0708027670784456 -0.5814 0.6534729839267632 0.6534713229115093 -1.222265168798753e-06 -0.0708103421182942 -0.5815 0.6534874588715246 0.6534858213757804 -1.2268676305993154e-06 -0.07081791552863145 -0.5816 0.6535019303344333 0.653500316446527 -1.2312357527966e-06 -0.07082548730963367 -0.5817 0.6535163983183868 0.653514808121983 -1.23536868351648e-06 -0.07083305746147722 -0.5818000000000001 0.6535308628262908 0.6535292964003752 -1.2392656173199068e-06 -0.07084062598433853 -0.5819 0.6535453238610589 0.6535437812799216 -1.242925795036376e-06 -0.07084819287839417 -0.582 0.6535597814256124 0.6535582627588337 -1.2463485047631284e-06 -0.07085575814382075 -0.5821000000000001 0.6535742355228791 0.6535727408353152 -1.249533080727172e-06 -0.0708633217807949 -0.5822 0.6535886861557929 0.6535872155075642 -1.2524789047008156e-06 -0.07087088378949334 -0.5823 0.6536031333272947 0.6536016867737724 -1.2551854052522682e-06 -0.07087844417009292 -0.5824 0.6536175770403301 0.6536161546321267 -1.2576520582729955e-06 -0.07088600292277061 -0.5825 0.6536320172978498 0.6536306190808088 -1.259878386894453e-06 -0.07089356004770331 -0.5826 0.6536464541028097 0.6536450801179952 -1.2618639618211525e-06 -0.07090111554506809 -0.5827 0.653660887458169 0.6536595377418594 -1.2636084010253512e-06 -0.07090866941504205 -0.5828000000000001 0.653675317366891 0.6536739919505704 -1.265111370191141e-06 -0.07091622165780236 -0.5829 0.653689743831942 0.6536884427422951 -1.2663725827144479e-06 -0.07092377227352635 -0.583 0.6537041668562908 0.6537028901151971 -1.2673917996475215e-06 -0.07093132126239132 -0.5831000000000001 0.6537185864429089 0.6537173340674384 -1.2681688296989346e-06 -0.07093886862457471 -0.5832 0.6537330025947692 0.6537317745971786 -1.268703529594406e-06 -0.07094641436025399 -0.5833 0.653747415314846 0.6537462117025769 -1.2689958037159776e-06 -0.07095395846960677 -0.5834 0.6537618246061141 0.6537606453817909 -1.269045604351815e-06 -0.07096150095281062 -0.5835 0.6537762304715486 0.6537750756329791 -1.268852931640696e-06 -0.07096904181004327 -0.5836 0.653790632914125 0.6537895024542992 -1.2684178335997665e-06 -0.07097658104148251 -0.5837 0.6538050319368176 0.6538039258439102 -1.267740405930251e-06 -0.07098411864730618 -0.5838000000000001 0.6538194275425996 0.6538183457999723 -1.2668207925170538e-06 -0.0709916546276922 -0.5839 0.6538338197344431 0.6538327623206472 -1.2656591848181353e-06 -0.07099918898281865 -0.584 0.6538482085153174 0.6538471754040986 -1.2642558221420686e-06 -0.07100672171286353 -0.5841000000000001 0.6538625938881895 0.6538615850484929 -1.2626109913982386e-06 -0.07101425281800494 -0.5842 0.6538769758560239 0.653875991252 -1.2607250274021542e-06 -0.07102178229842121 -0.5843 0.6538913544217811 0.6538903940127933 -1.2585983124591138e-06 -0.07102931015429062 -0.5844 0.6539057295884179 0.6539047933290496 -1.2562312762809391e-06 -0.07103683638579153 -0.5845 0.6539201013588862 0.6539191891989506 -1.2536243964300642e-06 -0.07104436099310237 -0.5846 0.6539344697361331 0.6539335816206829 -1.2507781975146237e-06 -0.0710518839764016 -0.5847 0.6539488347231008 0.6539479705924391 -1.2476932512439642e-06 -0.07105940533586787 -0.5848000000000001 0.6539631963227253 0.6539623561124168 -1.2443701769837556e-06 -0.07106692507167982 -0.5849 0.6539775545379365 0.6539767381788211 -1.2408096406735236e-06 -0.07107444318401622 -0.585 0.6539919093716569 0.6539911167898629 -1.2370123555205392e-06 -0.07108195967305585 -0.5851000000000001 0.6540062608268022 0.6540054919437608 -1.2329790813059294e-06 -0.07108947453897752 -0.5852 0.6540206089062808 0.6540198636387413 -1.2287106244124324e-06 -0.07109698778196029 -0.5853 0.654034953612992 0.6540342318730394 -1.2242078375190868e-06 -0.07110449940218315 -0.5854 0.6540492949498271 0.6540485966448981 -1.219471620073076e-06 -0.07111200939982512 -0.5855 0.6540636329196684 0.6540629579525705 -1.2145029172350164e-06 -0.07111951777506549 -0.5856 0.6540779675253878 0.6540773157943183 -1.2093027203230466e-06 -0.0711270245280834 -0.5857 0.6540922987698481 0.6540916701684143 -1.2038720662577163e-06 -0.07113452965905821 -0.5858000000000001 0.654106626655901 0.6541060210731411 -1.1982120375342298e-06 -0.07114203316816929 -0.5859 0.654120951186388 0.6541203685067926 -1.192323762028158e-06 -0.07114953505559612 -0.586 0.6541352723641385 0.6541347124676741 -1.1862084126068595e-06 -0.07115703532151825 -0.5861000000000001 0.6541495901919702 0.6541490529541027 -1.1798672070739702e-06 -0.0711645339661152 -0.5862 0.6541639046726886 0.6541633899644079 -1.1733014079751136e-06 -0.07117203098956663 -0.5863 0.654178215809087 0.6541777234969324 -1.1665123220705453e-06 -0.07117952639205243 -0.5864 0.6541925236039446 0.6541920535500314 -1.1595013002518861e-06 -0.07118702017375227 -0.5865 0.654206828060028 0.6542063801220741 -1.1522697374310997e-06 -0.07119451233484612 -0.5866 0.6542211291800888 0.654220703211444 -1.1448190719576257e-06 -0.07120200287551388 -0.5867 0.6542354269668651 0.6542350228165387 -1.137150785701646e-06 -0.07120949179593566 -0.5868000000000001 0.6542497214230791 0.6542493389357706 -1.1292664034157074e-06 -0.07121697909629145 -0.5869 0.6542640125514387 0.6542636515675685 -1.1211674924016535e-06 -0.07122446477676152 -0.587 0.6542783003546357 0.6542779607103761 -1.1128556625661368e-06 -0.07123194883752612 -0.5871000000000001 0.6542925848353454 0.6542922663626539 -1.1043325660597958e-06 -0.07123943127876556 -0.5872 0.6543068659962266 0.6543065685228782 -1.095599896500099e-06 -0.07124691210066017 -0.5873 0.6543211438399212 0.6543208671895431 -1.0866593890823673e-06 -0.07125439130339047 -0.5873999999999999 0.6543354183690543 0.6543351623611597 -1.0775128200524176e-06 -0.07126186888713693 -0.5875 0.6543496895862322 0.6543494540362578 -1.0681620065122743e-06 -0.07126934485208021 -0.5876 0.6543639574940434 0.6543637422133844 -1.0586088058650578e-06 -0.07127681919840098 -0.5877 0.6543782220950582 0.6543780268911061 -1.048855115481917e-06 -0.07128429192627998 -0.5878000000000001 0.6543924833918273 0.6543923080680079 -1.0389028724244742e-06 -0.07129176303589804 -0.5879 0.6544067413868823 0.6544065857426946 -1.0287540531117578e-06 -0.07129923252743604 -0.588 0.6544209960827345 0.6544208599137908 -1.0184106728483577e-06 -0.07130670040107492 -0.5881000000000001 0.654435247481876 0.6544351305799415 -1.0078747852415582e-06 -0.07131416665699572 -0.5882000000000001 0.6544494955867773 0.654449397739812 -9.971484820348042e-07 -0.07132163129537954 -0.5883 0.6544637403998887 0.6544636613920888 -9.862338927191239e-07 -0.07132909431640756 -0.5883999999999999 0.6544779819236388 0.6544779215354799 -9.751331840335276e-07 -0.07133655572026103 -0.5885 0.6544922201604347 0.6544921781687146 -9.638485594654078e-07 -0.0713440155071212 -0.5886 0.6545064551126614 0.6545064312905449 -9.523822588619613e-07 -0.07135147367716953 -0.5887 0.6545206867826813 0.6545206808997448 -9.407365580693661e-07 -0.07135893023058743 -0.5888000000000001 0.6545349151728345 0.6545349269951115 -9.289137684331816e-07 -0.07136638516755645 -0.5889 0.6545491402854373 0.6545491695754653 -9.169162362987482e-07 -0.07137383848825819 -0.589 0.6545633621227833 0.6545634086396497 -9.047463426503644e-07 -0.0713812901928743 -0.5891000000000001 0.6545775806871417 0.6545776441865323 -8.924065024451533e-07 -0.07138874028158652 -0.5892000000000001 0.6545917959807581 0.654591876215005 -8.798991642799958e-07 -0.07139618875457665 -0.5893 0.6546060080058529 0.6546061047239843 -8.672268101417302e-07 -0.0714036356120266 -0.5893999999999999 0.6546202167646223 0.6546203297124111 -8.54391954435707e-07 -0.07141108085411825 -0.5895 0.6546344222592372 0.654634551179252 -8.413971436804779e-07 -0.07141852448103367 -0.5896 0.654648624491843 0.6546487691234988 -8.282449561886063e-07 -0.07142596649295495 -0.5897 0.6546628234645595 0.6546629835441693 -8.149380014005336e-07 -0.07143340689006421 -0.5898000000000001 0.6546770191794802 0.6546771944403074 -8.014789193017124e-07 -0.0714408456725437 -0.5899 0.6546912116386724 0.6546914018109833 -7.878703800617837e-07 -0.07144828284057574 -0.59 0.6547054008441766 0.654705605655294 -7.741150834100763e-07 -0.07145571839434268 -0.5901000000000001 0.6547195867980065 0.6547198059723638 -7.60215758136007e-07 -0.07146315233402695 -0.5902000000000001 0.6547337695021482 0.6547340027613437 -7.461751615062129e-07 -0.07147058465981103 -0.5903 0.6547479489585607 0.6547481960214132 -7.319960787788293e-07 -0.07147801537187755 -0.5903999999999999 0.6547621251691751 0.6547623857517785 -7.176813225373557e-07 -0.07148544447040911 -0.5905 0.6547762981358944 0.6547765719516749 -7.032337323575888e-07 -0.0714928719555885 -0.5906 0.6547904678605931 0.6547907546203658 -6.886561740165886e-07 -0.07150029782759841 -0.5907 0.6548046343451173 0.6548049337571432 -6.739515390763451e-07 -0.07150772208662175 -0.5908000000000001 0.6548187975912839 0.654819109361328 -6.591227441760106e-07 -0.07151514473284143 -0.5909 0.6548329576008809 0.6548332814322702 -6.441727306016887e-07 -0.07152256576644042 -0.591 0.6548471143756673 0.6548474499693497 -6.291044636480558e-07 -0.07152998518760183 -0.5911000000000001 0.654861267917372 0.6548616149719753 -6.139209319522276e-07 -0.07153740299650874 -0.5912000000000001 0.6548754182276941 0.654875776439586 -5.986251470219139e-07 -0.07154481919334438 -0.5913 0.6548895653083034 0.6548899343716515 -5.832201425970407e-07 -0.07155223377829208 -0.5913999999999999 0.6549037091608386 0.6549040887676709 -5.677089740391272e-07 -0.07155964675153507 -0.5915 0.6549178497869081 0.654918239627174 -5.520947176373969e-07 -0.07156705811325681 -0.5916 0.6549319871880899 0.6549323869497219 -5.363804702340769e-07 -0.07157446786364079 -0.5917 0.6549461213659309 0.6549465307349064 -5.205693483362195e-07 -0.07158187600287057 -0.5918000000000001 0.6549602523219468 0.65496067098235 -5.046644877132467e-07 -0.07158928253112971 -0.5919 0.6549743800576225 0.6549748076917069 -4.886690427030604e-07 -0.07159668744860195 -0.592 0.6549885045744109 0.6549889408626629 -4.7258618550427567e-07 -0.07160409075547101 -0.5921000000000001 0.6550026258737336 0.6550030704949354 -4.564191057043754e-07 -0.07161149245192071 -0.5922000000000001 0.6550167439569804 0.6550171965882736 -4.401710095303102e-07 -0.07161889253813496 -0.5923 0.6550308588255089 0.6550313191424588 -4.238451192586923e-07 -0.07162629101429772 -0.5923999999999999 0.6550449704806449 0.6550454381573043 -4.0744467254272276e-07 -0.07163368788059303 -0.5925 0.6550590789236818 0.6550595536326557 -3.9097292182932453e-07 -0.07164108313720491 -0.5926 0.6550731841558803 0.6550736655683913 -3.7443313368606956e-07 -0.0716484767843176 -0.5927 0.655087286178469 0.6550877739644219 -3.578285880934118e-07 -0.07165586882211528 -0.5928000000000001 0.6551013849926438 0.6551018788206912 -3.4116257793120885e-07 -0.07166325925078229 -0.5929 0.6551154805995675 0.6551159801371754 -3.244384081946272e-07 -0.07167064807050301 -0.593 0.65512957300037 0.6551300779138842 -3.0765939541821385e-07 -0.07167803528146185 -0.5931000000000001 0.6551436621961482 0.65514417215086 -2.9082886697506805e-07 -0.07168542088384332 -0.5932000000000001 0.6551577481879661 0.6551582628481786 -2.739501604523409e-07 -0.07169280487783201 -0.5933 0.6551718309768543 0.6551723500059488 -2.570266229642848e-07 -0.07170018726361255 -0.5933999999999999 0.6551859105638098 0.6551864336243133 -2.4006161049305863e-07 -0.07170756804136967 -0.5935 0.6551999869497965 0.6552005137034478 -2.2305848720524657e-07 -0.07171494721128811 -0.5936 0.6552140601357447 0.6552145902435618 -2.0602062485858275e-07 -0.07172232477355274 -0.5937 0.655228130122551 0.6552286632448985 -1.889514020386729e-07 -0.07172970072834846 -0.5938000000000001 0.6552421969110785 0.6552427327077344 -1.7185420355878e-07 -0.07173707507586025 -0.5939 0.6552562605021568 0.6552567986323804 -1.547324197451183e-07 -0.07174444781627319 -0.594 0.6552703208965813 0.655270861019181 -1.3758944579500554e-07 -0.07175181894977238 -0.5941000000000001 0.6552843780951139 0.6552849198685139 -1.2042868106736104e-07 -0.07175918847654299 -0.5942000000000001 0.6552984320984824 0.6552989751807915 -1.0325352845820535e-07 -0.0717665563967703 -0.5943 0.6553124829073811 0.6553130269564601 -8.606739368421934e-08 -0.0717739227106396 -0.5943999999999999 0.6553265305224701 0.6553270751959994 -6.887368462615145e-08 -0.07178128741833632 -0.5945 0.6553405749443758 0.6553411198999233 -5.1675810644902925e-08 -0.07178865052004586 -0.5946 0.6553546161736904 0.65535516106878 -3.447718191084033e-08 -0.07179601201595377 -0.5947 0.6553686542109722 0.6553691987031515 -1.7281208724868186e-08 -0.07180337190624562 -0.5948000000000001 0.6553826890567458 0.6553832328036537 -9.130083841735193e-11 -0.0718107301911071 -0.5949 0.6553967207115019 0.6553972633709366 1.7089133216158237e-08 -0.07181808687072394 -0.595 0.6554107491756969 0.6554112904056839 3.425668681014682e-08 -0.07182544194528187 -0.5951000000000001 0.6554247744497538 0.6554253139086136 5.1407955890467316e-08 -0.07183279541496682 -0.5952000000000001 0.655438796534061 0.6554393338804775 6.853953964623682e-08 -0.07184014727996464 -0.5953 0.655452815428974 0.6554533503220612 8.564804119745584e-08 -0.0718474975404614 -0.5953999999999999 0.6554668311348137 0.6554673632341843 1.0273006827501985e-07 -0.0718548461966431 -0.5955 0.6554808436518678 0.6554813726177001 1.19782233881649e-07 -0.07186219324869586 -0.5956 0.6554948529803901 0.6554953784734955 1.3680115694414408e-07 -0.07186953869680593 -0.5957 0.655508859120601 0.6555093808024914 1.537834630402357e-07 -0.07187688254115955 -0.5958000000000001 0.6555228620726867 0.6555233796056421 1.7072578501614588e-07 -0.071884224781943 -0.5959 0.6555368618368007 0.6555373748839355 1.8762476367700787e-07 -0.07189156541934273 -0.596 0.6555508584130625 0.6555513666383928 2.0447704846687786e-07 -0.07189890445354519 -0.5961000000000001 0.6555648518015588 0.6555653548700687 2.2127929808629654e-07 -0.07190624188473686 -0.5962000000000001 0.6555788420023427 0.6555793395800512 2.3802818123475067e-07 -0.0719135777131044 -0.5963 0.6555928290154345 0.6555933207694614 2.5472037720047913e-07 -0.0719209119388344 -0.5963999999999999 0.6556068128408209 0.6556072984394534 2.713525765543623e-07 -0.07192824456211361 -0.5965 0.6556207934784565 0.6556212725912146 2.8792148178136134e-07 -0.07193557558312885 -0.5966 0.6556347709282627 0.6556352432259647 3.044238079813466e-07 -0.07194290500206695 -0.5967 0.6556487451901282 0.6556492103449563 3.2085628349359796e-07 -0.07195023281911483 -0.5968000000000001 0.6556627162639093 0.6556631739494749 3.372156505074275e-07 -0.0719575590344595 -0.5969 0.6556766841494299 0.6556771340408378 3.534986657907635e-07 -0.071964883648288 -0.597 0.6556906488464818 0.6556910906203952 3.6970210130077286e-07 -0.07197220666078744 -0.5971000000000001 0.6557046103548247 0.655705043689529 3.85822744794484e-07 -0.07197952807214505 -0.5972000000000001 0.6557185686741861 0.655718993249653 4.0185740052267604e-07 -0.07198684788254801 -0.5973 0.6557325238042622 0.6557329393022131 4.1780288979886837e-07 -0.07199416609218372 -0.5973999999999999 0.6557464757447171 0.6557468818486868 4.3365605169320975e-07 -0.0720014827012395 -0.5975 0.6557604244951842 0.6557608208905827 4.494137436222845e-07 -0.07200879770990286 -0.5976 0.6557743700552653 0.6557747564294415 4.6507284195973497e-07 -0.0720161111183613 -0.5977 0.6557883124245308 0.6557886884668337 4.806302427856624e-07 -0.07202342292680237 -0.5978000000000001 0.655802251602521 0.6558026170043614 4.960828623307156e-07 -0.07203073313541374 -0.5979 0.6558161875887455 0.6558165420436575 5.114276376005922e-07 -0.07203804174438314 -0.598 0.6558301203826828 0.6558304635863851 5.266615271531938e-07 -0.07204534875389831 -0.5981000000000001 0.6558440499837823 0.6558443816342374 5.417815115843494e-07 -0.07205265416414715 -0.5982000000000001 0.6558579763914621 0.6558582961889379 5.567845940829264e-07 -0.07205995797531749 -0.5983 0.6558718996051119 0.6558722072522397 5.7166780112472e-07 -0.07206726018759739 -0.5983999999999999 0.655885819624091 0.6558861148259258 5.864281829581763e-07 -0.07207456080117483 -0.5985 0.6558997364477296 0.6559000189118078 6.010628144231811e-07 -0.07208185981623794 -0.5986 0.6559136500753292 0.6559139195117274 6.155687952424937e-07 -0.07208915723297488 -0.5987 0.6559275605061624 0.655927816627554 6.299432507017588e-07 -0.0720964530515739 -0.5988000000000001 0.6559414677394734 0.6559417102611861 6.441833323850288e-07 -0.07210374727222334 -0.5989 0.6559553717744774 0.6559556004145508 6.582862184245641e-07 -0.07211103989511146 -0.599 0.6559692726103628 0.6559694870896026 6.722491143335008e-07 -0.07211833092042678 -0.5991000000000001 0.6559831702462893 0.6559833702883242 6.86069253519328e-07 -0.07212562034835777 -0.5992000000000001 0.6559970646813897 0.6559972500127256 6.997438976724668e-07 -0.07213290817909297 -0.5993 0.6560109559147697 0.6560111262648441 7.132703375017924e-07 -0.07214019441282106 -0.5993999999999999 0.6560248439455079 0.6560249990467437 7.266458932203568e-07 -0.07214747904973069 -0.5995 0.6560387287726562 0.6560388683605151 7.398679149339671e-07 -0.0721547620900106 -0.5996 0.6560526103952407 0.6560527342082753 7.529337834044636e-07 -0.07216204353384963 -0.5997 0.6560664888122614 0.6560665965921673 7.658409103827868e-07 -0.07216932338143664 -0.5998000000000001 0.6560803640226928 0.6560804555143599 7.785867392751111e-07 -0.07217660163296062 -0.5999 0.6560942360254836 0.6560943109770471 7.911687455175453e-07 -0.0721838782886106 -0.6 0.6561081048195578 0.6561081629824479 8.035844371312439e-07 -0.0721911533485756 -0.6001000000000001 0.6561219704038147 0.6561220115328062 8.158313553330299e-07 -0.07219842681304477 -0.6002000000000001 0.6561358327771297 0.6561358566303903 8.279070746741723e-07 -0.07220569868220737 -0.6003000000000001 0.6561496919383534 0.656149698277492 8.398092040673433e-07 -0.0722129689562526 -0.6003999999999999 0.6561635478863129 0.6561635364764278 8.515353868143727e-07 -0.07222023763536982 -0.6005 0.6561774006198128 0.6561773712295366 8.630833012446271e-07 -0.07222750471974845 -0.6006 0.6561912501376339 0.6561912025391806 8.744506610203207e-07 -0.07223477020957791 -0.6007 0.6562050964385345 0.6562050304077454 8.856352159691827e-07 -0.07224203410504779 -0.6008000000000001 0.6562189395212511 0.6562188548376376 8.966347522232354e-07 -0.07224929640634763 -0.6009 0.6562327793844978 0.6562326758312867 9.074470927183942e-07 -0.07225655711366709 -0.601 0.6562466160269675 0.6562464933911436 9.180700975830458e-07 -0.07226381622719591 -0.6011 0.6562604494473319 0.6562603075196797 9.285016646098931e-07 -0.07227107374712383 -0.6012000000000001 0.6562742796442418 0.6562741182193881 9.387397298388223e-07 -0.07227832967364074 -0.6013000000000001 0.6562881066163277 0.656287925492782 9.487822676679247e-07 -0.07228558400693655 -0.6013999999999999 0.6563019303622006 0.6563017293423945 9.586272913808536e-07 -0.0722928367472012 -0.6015 0.6563157508804511 0.6563155297707783 9.682728537574459e-07 -0.0723000878946248 -0.6016 0.6563295681696508 0.6563293267805058 9.777170472402563e-07 -0.0723073374493974 -0.6017 0.6563433822283528 0.6563431203741678 9.869580042121129e-07 -0.07231458541170911 -0.6018000000000001 0.6563571930550911 0.6563569105543735 9.959938976622507e-07 -0.07232183178175018 -0.6019 0.6563710006483829 0.6563706973237509 1.0048229411863119e-06 -0.07232907655971098 -0.602 0.6563848050067268 0.6563844806849449 1.0134433897912576e-06 -0.07233631974578185 -0.6021 0.6563986061286042 0.6563982606406178 1.0218535398953676e-06 -0.07234356134015316 -0.6022000000000001 0.6564124040124804 0.6564120371934485 1.030051729827841e-06 -0.07235080134301533 -0.6023000000000001 0.6564261986568036 0.656425810346133 1.0380363400230852e-06 -0.07235803975455901 -0.6023999999999999 0.6564399900600068 0.6564395801013827 1.0458057935203158e-06 -0.07236527657497478 -0.6025 0.6564537782205069 0.6564533464619247 1.0533585561578462e-06 -0.07237251180445328 -0.6026 0.656467563136706 0.656467109430501 1.0606931369616657e-06 -0.07237974544318529 -0.6027 0.6564813448069915 0.6564808690098687 1.0678080883397278e-06 -0.07238697749136155 -0.6028000000000001 0.6564951232297367 0.656494625202799 1.0747020064982848e-06 -0.07239420794917295 -0.6029 0.6565088984033006 0.6565083780120768 1.0813735315251538e-06 -0.07240143681681042 -0.603 0.65652267032603 0.6565221274405008 1.0878213479170729e-06 -0.07240866409446496 -0.6031 0.6565364389962576 0.6565358734908817 1.0940441846907234e-06 -0.07241588978232759 -0.6032000000000001 0.6565502044123042 0.6565496161660438 1.1000408156325303e-06 -0.07242311388058943 -0.6033000000000001 0.6565639665724784 0.6565633554688224 1.1058100596317288e-06 -0.07243033638944162 -0.6033999999999999 0.6565777254750778 0.6565770914020652 1.111350780791387e-06 -0.07243755730907545 -0.6035 0.6565914811183884 0.656590823968631 1.116661888705961e-06 -0.07244477663968221 -0.6036 0.6566052335006853 0.6566045531713884 1.1217423388221182e-06 -0.07245199438145321 -0.6037 0.656618982620234 0.6566182790132173 1.1265911323277145e-06 -0.07245921053457986 -0.6038000000000001 0.65663272847529 0.656632001497007 1.1312073167069059e-06 -0.07246642509925372 -0.6039 0.6566464710640996 0.6566457206256557 1.135589985712393e-06 -0.0724736380756663 -0.604 0.6566602103849004 0.6566594364020709 1.1397382797262434e-06 -0.0724808494640092 -0.6041 0.6566739464359215 0.6566731488291685 1.1436513855656028e-06 -0.07248805926447413 -0.6042000000000001 0.6566876792153841 0.6566868579098719 1.1473285370933173e-06 -0.07249526747725278 -0.6043000000000001 0.6567014087215022 0.6567005636471123 1.1507690152456895e-06 -0.07250247410253699 -0.6043999999999999 0.6567151349524828 0.6567142660438279 1.153972147921456e-06 -0.07250967914051858 -0.6045 0.6567288579065262 0.6567279651029629 1.1569373102315872e-06 -0.0725168825913895 -0.6046 0.6567425775818271 0.6567416608274683 1.1596639249711327e-06 -0.07252408445534174 -0.6047 0.6567562939765742 0.6567553532203002 1.1621514622583984e-06 -0.07253128473256727 -0.6048000000000001 0.656770007088952 0.6567690422844195 1.1643994398680135e-06 -0.07253848342325829 -0.6049 0.6567837169171392 0.656782728022792 1.1664074232864419e-06 -0.07254568052760686 -0.605 0.6567974234593115 0.656796410438388 1.168175025878515e-06 -0.07255287604580528 -0.6051 0.6568111267136407 0.6568100895341811 1.1697019088596772e-06 -0.07256006997804586 -0.6052000000000001 0.6568248266782951 0.6568237653131477 1.1709877814070069e-06 -0.07256726232452093 -0.6053000000000001 0.6568385233514409 0.6568374377782674 1.1720324007979954e-06 -0.07257445308542289 -0.6053999999999999 0.6568522167312415 0.656851106932522 1.1728355722440131e-06 -0.07258164226094421 -0.6055 0.6568659068158591 0.656864772778895 1.173397149251132e-06 -0.07258882985127744 -0.6056 0.6568795936034546 0.6568784353203705 1.1737170332037916e-06 -0.07259601585661517 -0.6057 0.6568932770921883 0.6568920945599345 1.173795173892156e-06 -0.07260320027715006 -0.6058000000000001 0.6569069572802195 0.6569057505005724 1.1736315691790455e-06 -0.07261038311307486 -0.6059 0.6569206341657088 0.65691940314527 1.1732262650832048e-06 -0.07261756436458232 -0.606 0.6569343077468169 0.6569330524970118 1.1725793559180797e-06 -0.0726247440318653 -0.6061 0.6569479780217058 0.6569466985587815 1.1716909839309952e-06 -0.0726319221151167 -0.6062000000000001 0.6569616449885392 0.6569603413335614 1.1705613396084669e-06 -0.07263909861452948 -0.6063000000000001 0.6569753086454826 0.6569739808243313 1.1691906615651781e-06 -0.07264627353029669 -0.6063999999999999 0.6569889689907047 0.6569876170340687 1.1675792364884696e-06 -0.07265344686261137 -0.6065 0.6570026260223771 0.6570012499657476 1.1657273987775163e-06 -0.07266061861166671 -0.6066 0.6570162797386749 0.6570148796223386 1.163635531181706e-06 -0.0726677887776559 -0.6067 0.6570299301377774 0.6570285060068088 1.161304063884705e-06 -0.07267495736077222 -0.6068000000000001 0.6570435772178683 0.6570421291221202 1.1587334751150813e-06 -0.07268212436120901 -0.6069 0.6570572209771365 0.6570557489712299 1.155924290563437e-06 -0.07268928977915963 -0.607 0.6570708614137762 0.6570693655570896 1.1528770836599644e-06 -0.07269645361481757 -0.6071 0.6570844985259876 0.657082978882645 1.1495924752136233e-06 -0.07270361586837629 -0.6072000000000001 0.6570981323119778 0.6570965889508358 1.146071133273363e-06 -0.07271077654002943 -0.6073000000000001 0.6571117627699601 0.6571101957645942 1.142313773128123e-06 -0.07271793562997057 -0.6073999999999999 0.6571253898981555 0.6571237993268453 1.1383211572513208e-06 -0.07272509313839345 -0.6075 0.657139013694793 0.6571373996405062 1.134094094829008e-06 -0.07273224906549174 -0.6076 0.6571526341581102 0.6571509967084865 1.1296334418431364e-06 -0.07273940341145939 -0.6077 0.6571662512863525 0.6571645905336861 1.1249401008772697e-06 -0.07274655617649017 -0.6078000000000001 0.6571798650777756 0.6571781811189961 1.120015021033316e-06 -0.07275370736077805 -0.6079 0.6571934755306443 0.6571917684672974 1.1148591973764166e-06 -0.072760856964517 -0.608 0.6572070826432341 0.6572053525814618 1.1094736709904574e-06 -0.07276800498790113 -0.6081 0.6572206864138304 0.6572189334643496 1.103859529005824e-06 -0.0727751514311245 -0.6082000000000001 0.6572342868407303 0.6572325111188104 1.098017904016535e-06 -0.07278229629438134 -0.6083000000000001 0.6572478839222422 0.657246085547682 1.091949973802686e-06 -0.0727894395778658 -0.6083999999999999 0.6572614776566865 0.6572596567537907 1.0856569614969835e-06 -0.07279658128177223 -0.6085 0.6572750680423964 0.65727322473995 1.0791401348908547e-06 -0.07280372140629499 -0.6086 0.6572886550777176 0.6572867895089608 1.0724008067120039e-06 -0.07281085995162853 -0.6087 0.6573022387610092 0.6573003510636105 1.0654403339027674e-06 -0.07281799691796727 -0.6088000000000001 0.6573158190906442 0.6573139094066727 1.0582601174258244e-06 -0.07282513230550576 -0.6089 0.65732939606501 0.6573274645409068 1.0508616020976635e-06 -0.07283226611443859 -0.609 0.6573429696825082 0.6573410164690578 1.0432462762555161e-06 -0.07283939834496046 -0.6091 0.6573565399415559 0.6573545651938557 1.0354156716463336e-06 -0.07284652899726606 -0.6092000000000001 0.6573701068405855 0.6573681107180145 1.0273713627884096e-06 -0.07285365807155013 -0.6093000000000001 0.6573836703780451 0.6573816530442325 1.0191149668603572e-06 -0.07286078556800747 -0.6093999999999999 0.6573972305524001 0.6573951921751919 1.0106481433957981e-06 -0.07286791148683304 -0.6095 0.657410787362132 0.6574087281135579 1.0019725937004953e-06 -0.0728750358282218 -0.6096 0.6574243408057394 0.6574222608619789 9.930900609356197e-07 -0.07288215859236875 -0.6097 0.6574378908817391 0.6574357904230849 9.840023293961053e-07 -0.07288927977946895 -0.6098000000000001 0.6574514375886651 0.6574493167994884 9.74711224399627e-07 -0.07289639938971744 -0.6099 0.6574649809250709 0.6574628399937836 9.652186117314887e-07 -0.07290351742330956 -0.61 0.657478520889528 0.6574763600085458 9.555263975058459e-07 -0.07291063388044045 -0.6101 0.6574920574806278 0.6574898768463306 9.456365275550827e-07 -0.07291774876130547 -0.6102000000000001 0.6575055906969808 0.6575033905096748 9.355509870412337e-07 -0.07292486206609997 -0.6103000000000001 0.6575191205372177 0.6575169010010946 9.252718003449623e-07 -0.07293197379501935 -0.6103999999999999 0.65753264699999 0.6575304083230862 9.148010303161591e-07 -0.07293908394825918 -0.6105 0.6575461700839698 0.6575439124781245 9.041407781074096e-07 -0.07294619252601493 -0.6106 0.65755968978785 0.6575574134686634 8.932931825911261e-07 -0.0729532995284822 -0.6107 0.6575732061103454 0.6575709112971353 8.822604202485262e-07 -0.07296040495585664 -0.6108000000000001 0.6575867190501933 0.657584405965951 8.710447041426761e-07 -0.07296750880833403 -0.6109 0.6576002286061522 0.6575978974774986 8.596482840850239e-07 -0.07297461108611007 -0.611 0.6576137347770038 0.6576113858341437 8.480734458304884e-07 -0.07298171178938061 -0.6111 0.6576272375615535 0.6576248710382289 8.363225107443917e-07 -0.07298881091834158 -0.6112000000000001 0.6576407369586291 0.6576383530920735 8.243978352195924e-07 -0.07299590847318892 -0.6113000000000001 0.6576542329670826 0.6576518319979731 8.123018103711743e-07 -0.07300300445411866 -0.6113999999999999 0.6576677255857897 0.657665307758199 8.000368615368458e-07 -0.07301009886132678 -0.6115 0.6576812148136513 0.6576787803749986 7.876054478606065e-07 -0.07301719169500955 -0.6116 0.6576947006495923 0.6576922498505939 7.750100614045685e-07 -0.07302428295536303 -0.6117 0.6577081830925632 0.6577057161871824 7.622532270795679e-07 -0.07303137264258357 -0.6118000000000001 0.6577216621415394 0.6577191793869361 7.493375020484194e-07 -0.07303846075686736 -0.6119 0.6577351377955223 0.6577326394520009 7.362654751014164e-07 -0.07304554729841083 -0.612 0.6577486100535395 0.6577460963844972 7.230397662538746e-07 -0.07305263226741035 -0.6121 0.6577620789146448 0.657759550186519 7.096630261493875e-07 -0.07305971566406246 -0.6122000000000001 0.6577755443779187 0.6577730008601335 6.961379355741038e-07 -0.07306679748856368 -0.6123000000000001 0.6577890064424686 0.6577864484073808 6.824672048322267e-07 -0.07307387774111056 -0.6123999999999999 0.6578024651074292 0.6577998928302741 6.686535733851917e-07 -0.07308095642189978 -0.6125 0.6578159203719629 0.6578133341307989 6.546998090745104e-07 -0.07308803353112805 -0.6126 0.6578293722352594 0.6578267723109132 6.406087077193146e-07 -0.07309510906899212 -0.6127 0.657842820696537 0.6578402073725464 6.263830926028779e-07 -0.07310218303568879 -0.6128000000000001 0.6578562657550421 0.6578536393176 6.120258137509715e-07 -0.07310925543141493 -0.6129 0.6578697074100501 0.6578670681479468 5.975397474877742e-07 -0.07311632625636753 -0.613 0.657883145660865 0.6578804938654306 5.829277958113721e-07 -0.0731233955107436 -0.6131 0.65789658050682 0.6578939164718661 5.681928858386476e-07 -0.0731304631947401 -0.6132000000000001 0.6579100119472776 0.6579073359690387 5.533379691807783e-07 -0.0731375293085542 -0.6133000000000001 0.6579234399816304 0.6579207523587042 5.383660213603703e-07 -0.0731445938523831 -0.6134 0.6579368646093005 0.6579341656425886 5.232800412563465e-07 -0.07315165682642402 -0.6135 0.6579502858297396 0.6579475758223874 5.080830504794465e-07 -0.07315871823087414 -0.6136 0.6579637036424308 0.6579609828997666 4.92778092775481e-07 -0.07316577806593089 -0.6137 0.6579771180468874 0.6579743868763608 4.773682333730767e-07 -0.07317283633179165 -0.6138000000000001 0.6579905290426529 0.6579877877537743 4.6185655847019724e-07 -0.0731798930286539 -0.6139 0.6580039366293023 0.6580011855335802 4.4624617449862125e-07 -0.07318694815671505 -0.614 0.6580173408064417 0.6580145802173212 4.3054020759658584e-07 -0.07319400171617277 -0.6141 0.6580307415737089 0.6580279718065077 4.1474180295653085e-07 -0.07320105370722467 -0.6142000000000001 0.6580441389307722 0.658041360302619 3.9885412411733157e-07 -0.07320810413006837 -0.6143000000000001 0.658057532877333 0.6580547457071027 3.8288035243694285e-07 -0.07321515298490167 -0.6144000000000001 0.6580709234131237 0.6580681280213745 3.66823686509532e-07 -0.07322220027192237 -0.6145 0.6580843105379088 0.6580815072468179 3.506873413536282e-07 -0.07322924599132828 -0.6146 0.6580976942514858 0.6580948833847843 3.3447454782231656e-07 -0.07323629014331733 -0.6147 0.6581110745536836 0.6581082564365925 3.1818855206200425e-07 -0.07324333272808745 -0.6148 0.6581244514443645 0.6581216264035296 3.0183261478383683e-07 -0.07325037374583669 -0.6149000000000001 0.6581378249234228 0.6581349932868485 2.854100105281754e-07 -0.07325741319676311 -0.615 0.6581511949907863 0.658148357087771 2.6892402720662956e-07 -0.07326445108106487 -0.6151 0.6581645616464151 0.6581617178074849 2.5237796528326806e-07 -0.07327148739894017 -0.6152000000000001 0.658177924890303 0.6581750754471452 2.35775137163996e-07 -0.07327852215058724 -0.6153000000000001 0.6581912847224768 0.6581884300078735 2.191188665651156e-07 -0.07328555533620437 -0.6154000000000001 0.6582046411429961 0.6582017814907589 2.0241248779861998e-07 -0.07329258695598993 -0.6155 0.6582179941519547 0.6582151298968559 1.856593451268762e-07 -0.07329961701014234 -0.6156 0.6582313437494793 0.6582284752271863 1.6886279208955246e-07 -0.07330664549886004 -0.6157 0.6582446899357308 0.6582418174827385 1.5202619087217872e-07 -0.07331367242234159 -0.6158 0.6582580327109032 0.6582551566644668 1.3515291154980735e-07 -0.0733206977807856 -0.6159000000000001 0.6582713720752245 0.6582684927732918 1.182463314902682e-07 -0.07332772157439064 -0.616 0.6582847080289562 0.6582818258101003 1.0130983463599308e-07 -0.07333474380335545 -0.6161 0.6582980405723946 0.6582951557757454 8.434681085869866e-08 -0.07334176446787875 -0.6162000000000001 0.6583113697058692 0.6583084826710464 6.736065523427204e-08 -0.07334878356815942 -0.6163000000000001 0.6583246954297435 0.6583218064967882 5.035476739745359e-08 -0.07335580110439625 -0.6164000000000001 0.6583380177444154 0.6583351272537217 3.333255086529485e-08 -0.07336281707678816 -0.6165 0.6583513366503165 0.6583484449425641 1.6297412329391303e-08 -0.07336983148553415 -0.6166 0.6583646521479131 0.6583617595639983 -7.472389911694632e-10 -0.07337684433083326 -0.6167 0.6583779642377048 0.6583750711186733 -1.779799207839161e-08 -0.07338385561288456 -0.6168 0.6583912729202261 0.6583883796072036 -3.485143475808611e-08 -0.07339086533188721 -0.6169000000000001 0.6584045781960453 0.6584016850301699 -5.190415439441064e-08 -0.0733978734880404 -0.617 0.6584178800657647 0.6584149873881185 -6.895273858180742e-08 -0.07340488008154336 -0.6171 0.6584311785300211 0.6584282866815618 -8.599377582414747e-08 -0.07341188511259542 -0.6172000000000001 0.6584444735894853 0.6584415829109782 -1.0302385621517585e-07 -0.07341888858139593 -0.6173000000000001 0.6584577652448622 0.6584548760768114 -1.20039572124378e-07 -0.07342589048814432 -0.6174000000000001 0.6584710534968907 0.6584681661794718 -1.3703751887417237e-07 -0.07343289083304004 -0.6175 0.658484338346344 0.6584814532193349 -1.5401429543510092e-07 -0.07343988961628266 -0.6176 0.6584976197940291 0.658494737196743 -1.7096650509196287e-07 -0.07344688683807171 -0.6177 0.6585108978407872 0.6585080181120041 -1.8789075612729578e-07 -0.07345388249860689 -0.6178 0.658524172487493 0.6585212959653923 -2.047836625135302e-07 -0.07346087659808782 -0.6179000000000001 0.6585374437350556 0.6585345707571478 -2.216418445721846e-07 -0.07346786913671433 -0.618 0.6585507115844177 0.6585478424874772 -2.3846192967122426e-07 -0.07347486011468618 -0.6181 0.6585639760365555 0.6585611111565532 -2.552405528738477e-07 -0.0734818495322032 -0.6182000000000001 0.658577237092479 0.6585743767645154 -2.71974357653193e-07 -0.07348883738946538 -0.6183000000000001 0.6585904947532318 0.6585876393114687 -2.886599965445935e-07 -0.07349582368667261 -0.6184000000000001 0.658603749019891 0.6586008987974855 -3.0529413174579245e-07 -0.07350280842402494 -0.6185 0.6586169998935669 0.6586141552226052 -3.218734359530795e-07 -0.07350979160172247 -0.6186 0.6586302473754034 0.6586274085868328 -3.3839459285395224e-07 -0.07351677321996529 -0.6187 0.6586434914665771 0.6586406588901412 -3.5485429792508905e-07 -0.07352375327895365 -0.6188 0.6586567321682978 0.6586539061324697 -3.7124925895970495e-07 -0.07353073177888775 -0.6189000000000001 0.6586699694818081 0.6586671503137247 -3.8757619691409673e-07 -0.07353770871996786 -0.619 0.6586832034083839 0.6586803914337804 -4.038318463309154e-07 -0.07354468410239438 -0.6191 0.6586964339493329 0.6586936294924779 -4.200129561926502e-07 -0.07355165792636767 -0.6192000000000001 0.6587096611059959 0.6587068644896259 -4.3611629049755685e-07 -0.07355863019208823 -0.6193000000000001 0.658722884879746 0.658720096425001 -4.521386288633411e-07 -0.07356560089975654 -0.6194000000000001 0.6587361052719879 0.6587333252983476 -4.6807676727655956e-07 -0.07357257004957318 -0.6195 0.6587493222841588 0.6587465511093782 -4.839275186685477e-07 -0.07357953764173877 -0.6196 0.6587625359177276 0.658759773857773 -4.996877135260425e-07 -0.073586503676454 -0.6197 0.6587757461741949 0.6587729935431813 -5.153542005226219e-07 -0.07359346815391958 -0.6198 0.6587889530550926 0.6587862101652205 -5.309238473860667e-07 -0.07360043107433631 -0.6199000000000001 0.6588021565619839 0.6587994237234766 -5.463935411065268e-07 -0.07360739243790497 -0.62 0.6588153566964634 0.6588126342175051 -5.617601889634782e-07 -0.07361435224482656 -0.6201 0.6588285534601561 0.6588258416468304 -5.770207187894005e-07 -0.07362131049530195 -0.6202000000000001 0.6588417468547179 0.6588390460109459 -5.921720799273444e-07 -0.07362826718953214 -0.6203000000000001 0.6588549368818353 0.6588522473093149 -6.072112436611432e-07 -0.07363522232771819 -0.6204000000000001 0.6588681235432244 0.6588654455413708 -6.221352037288908e-07 -0.07364217591006124 -0.6205 0.6588813068406318 0.6588786407065164 -6.369409771694867e-07 -0.07364912793676236 -0.6206 0.6588944867758343 0.658891832804125 -6.516256047806035e-07 -0.07365607840802284 -0.6207 0.658907663350637 0.6589050218335407 -6.661861516737977e-07 -0.07366302732404394 -0.6208 0.6589208365668755 0.6589182077940782 -6.80619707871255e-07 -0.07366997468502698 -0.6209000000000001 0.6589340064264136 0.6589313906850227 -6.949233890690687e-07 -0.07367692049117329 -0.621 0.658947172931144 0.6589445705056316 -7.090943369564284e-07 -0.07368386474268436 -0.6211 0.6589603360829882 0.6589577472551331 -7.231297200066544e-07 -0.07369080743976163 -0.6212000000000001 0.6589734958838958 0.6589709209327274 -7.370267338796532e-07 -0.07369774858260665 -0.6213000000000001 0.6589866523358439 0.6589840915375866 -7.507826021435626e-07 -0.07370468817142099 -0.6214000000000001 0.6589998054408379 0.6589972590688555 -7.643945765939408e-07 -0.0737116262064063 -0.6215 0.6590129552009104 0.6590104235256514 -7.778599381280671e-07 -0.07371856268776425 -0.6216 0.6590261016181208 0.6590235849070645 -7.911759970363752e-07 -0.0737254976156966 -0.6217 0.6590392446945558 0.6590367432121579 -8.043400936685874e-07 -0.0737324309904052 -0.6218 0.659052384432328 0.6590498984399689 -8.173495988084145e-07 -0.07373936281209181 -0.6219000000000001 0.6590655208335767 0.6590630505895079 -8.302019144784678e-07 -0.07374629308095841 -0.622 0.6590786539004668 0.6590761996597603 -8.428944742039368e-07 -0.07375322179720695 -0.6221 0.6590917836351888 0.659089345649685 -8.554247436648454e-07 -0.07376014896103941 -0.6222000000000001 0.6591049100399583 0.6591024885582166 -8.677902211401411e-07 -0.07376707457265788 -0.6223000000000001 0.6591180331170159 0.6591156283842642 -8.79988438090562e-07 -0.07377399863226446 -0.6224000000000001 0.6591311528686268 0.6591287651267126 -8.920169595472149e-07 -0.0737809211400613 -0.6225 0.6591442692970804 0.6591418987844222 -9.038733846944424e-07 -0.07378784209625062 -0.6226 0.6591573824046898 0.65915502935623 -9.155553472028899e-07 -0.07379476150103478 -0.6227 0.659170492193792 0.6591681568409489 -9.27060515965028e-07 -0.073801679354616 -0.6228 0.6591835986667469 0.6591812812373692 -9.383865952894421e-07 -0.07380859565719673 -0.6229000000000001 0.6591967018259371 0.6591944025442577 -9.495313255947213e-07 -0.07381551040897934 -0.623 0.6592098016737684 0.6592075207603595 -9.6049248371477e-07 -0.0738224236101664 -0.6231 0.6592228982126673 0.659220635884397 -9.712678832873856e-07 -0.07382933526096036 -0.6232000000000001 0.6592359914450834 0.6592337479150718 -9.81855375420393e-07 -0.07383624536156384 -0.6233000000000001 0.6592490813734868 0.6592468568510632 -9.92252848996955e-07 -0.07384315391217951 -0.6234000000000001 0.6592621680003687 0.6592599626910297 -1.0024582309531294e-06 -0.07385006091300998 -0.6235 0.6592752513282414 0.6592730654336099 -1.0124694869162454e-06 -0.07385696636425808 -0.6236 0.6592883313596365 0.6592861650774213 -1.02228462167675e-06 -0.07386387026612654 -0.6237 0.6593014080971062 0.6592992616210628 -1.031901679215963e-06 -0.07387077261881825 -0.6238 0.6593144815432219 0.6593123550631127 -1.0413187434832327e-06 -0.07387767342253614 -0.6239000000000001 0.6593275517005734 0.659325445402131 -1.0505339386179813e-06 -0.07388457267748309 -0.624 0.6593406185717698 0.6593385326366593 -1.0595454291717488e-06 -0.07389147038386218 -0.6241 0.6593536821594385 0.6593516167652202 -1.068351420857594e-06 -0.07389836654187641 -0.6242000000000001 0.6593667424662237 0.6593646977863195 -1.0769501605500942e-06 -0.07390526115172892 -0.6243000000000001 0.6593797994947876 0.6593777756984448 -1.085339936979235e-06 -0.07391215421362282 -0.6244000000000001 0.6593928532478099 0.6593908505000674 -1.0935190805916317e-06 -0.07391904572776138 -0.6245 0.6594059037279856 0.659403922189642 -1.1014859644942199e-06 -0.07392593569434786 -0.6246 0.6594189509380266 0.6594169907656071 -1.1092390041766986e-06 -0.07393282411358554 -0.6247 0.6594319948806601 0.6594300562263855 -1.1167766582609318e-06 -0.0739397109856778 -0.6248 0.659445035558629 0.6594431185703848 -1.1240974286397254e-06 -0.0739465963108281 -0.6249000000000001 0.6594580729746904 0.6594561777959979 -1.1311998608376506e-06 -0.07395348008923985 -0.625 0.659471107131616 0.6594692339016033 -1.1380825442053322e-06 -0.07396036232111657 -0.6251 0.6594841380321914 0.6594822868855656 -1.1447441123357827e-06 -0.07396724300666184 -0.6252000000000001 0.6594971656792159 0.6594953367462361 -1.1511832432309355e-06 -0.07397412214607928 -0.6253000000000001 0.6595101900755014 0.6595083834819528 -1.1573986596069563e-06 -0.07398099973957258 -0.6254000000000001 0.6595232112238727 0.6595214270910416 -1.1633891291162879e-06 -0.07398787578734545 -0.6255 0.6595362291271665 0.6595344675718158 -1.1691534647084723e-06 -0.07399475028960166 -0.6256 0.6595492437882313 0.6595475049225772 -1.1746905247689288e-06 -0.07400162324654506 -0.6257 0.6595622552099268 0.6595605391416166 -1.179999213313243e-06 -0.07400849465837955 -0.6258 0.6595752633951235 0.6595735702272141 -1.1850784802924785e-06 -0.07401536452530903 -0.6259000000000001 0.6595882683467018 0.6595865981776388 -1.1899273220650208e-06 -0.07402223284753746 -0.626 0.6596012700675525 0.6595996229911509 -1.1945447808414666e-06 -0.07402909962526891 -0.6261 0.6596142685605755 0.6596126446660009 -1.1989299455172908e-06 -0.07403596485870743 -0.6262000000000001 0.6596272638286795 0.6596256632004303 -1.203081951756113e-06 -0.07404282854805717 -0.6263000000000001 0.6596402558747814 0.6596386785926722 -1.2069999821562316e-06 -0.0740496906935223 -0.6264000000000001 0.6596532447018066 0.659651690840952 -1.2106832662506228e-06 -0.07405655129530704 -0.6265 0.6596662303126879 0.6596646999434874 -1.2141310807289862e-06 -0.0740634103536157 -0.6266 0.6596792127103646 0.6596777058984893 -1.2173427497430556e-06 -0.07407026786865262 -0.6267 0.6596921918977832 0.6596907087041618 -1.2203176447955766e-06 -0.07407712384062218 -0.6268 0.6597051678778956 0.659703708358703 -1.2230551851011295e-06 -0.07408397826972878 -0.6269000000000001 0.6597181406536597 0.6597167048603059 -1.2255548373918401e-06 -0.07409083115617697 -0.627 0.6597311102280385 0.6597296982071579 -1.2278161166112689e-06 -0.07409768250017128 -0.6271 0.6597440766039995 0.659742688397442 -1.2298385852482774e-06 -0.07410453230191627 -0.6272000000000001 0.659757039784514 0.6597556754293368 -1.2316218540586732e-06 -0.07411138056161655 -0.6273000000000001 0.6597699997725572 0.6597686593010175 -1.233165581732143e-06 -0.0741182272794768 -0.6274000000000001 0.6597829565711082 0.6597816400106566 -1.2344694750865415e-06 -0.07412507245570185 -0.6275 0.6597959101831479 0.6597946175564229 -1.235533289428714e-06 -0.07413191609049644 -0.6276 0.6598088606116592 0.6598075919364839 -1.2363568279993853e-06 -0.07413875818406536 -0.6277 0.6598218078596274 0.6598205631490048 -1.2369399426392924e-06 -0.07414559873661353 -0.6278 0.6598347519300387 0.6598335311921499 -1.237282533317341e-06 -0.07415243774834589 -0.6279000000000001 0.6598476928258805 0.6598464960640831 -1.237384548491427e-06 -0.07415927521946745 -0.628 0.6598606305501395 0.6598594577629668 -1.2372459848863926e-06 -0.07416611115018319 -0.6281 0.6598735651058035 0.6598724162869649 -1.2368668877160705e-06 -0.07417294554069824 -0.6282000000000001 0.6598864964958586 0.6598853716342414 -1.2362473504889948e-06 -0.07417977839121775 -0.6283000000000001 0.6598994247232897 0.6598983238029619 -1.235387514980646e-06 -0.07418660970194689 -0.6284000000000001 0.6599123497910808 0.659911272791293 -1.2342875715387613e-06 -0.07419343947309089 -0.6285 0.6599252717022126 0.6599242185974044 -1.2329477585004689e-06 -0.07420026770485498 -0.6286 0.6599381904596645 0.6599371612194678 -1.2313683625253535e-06 -0.07420709439744462 -0.6287 0.6599511060664114 0.6599501006556578 -1.229549718623213e-06 -0.07421391955106509 -0.6288 0.6599640185254256 0.6599630369041537 -1.2274922096822127e-06 -0.07422074316592185 -0.6289000000000001 0.6599769278396751 0.6599759699631378 -1.2251962666631755e-06 -0.07422756524222043 -0.629 0.6599898340121229 0.6599888998307974 -1.2226623686828475e-06 -0.07423438578016632 -0.6291 0.6600027370457273 0.6600018265053247 -1.219891042403276e-06 -0.07424120477996506 -0.6292000000000001 0.6600156369434411 0.660014749984918 -1.2168828624481431e-06 -0.07424802224182236 -0.6293000000000001 0.6600285337082106 0.6600276702677811 -1.2136384509309206e-06 -0.07425483816594385 -0.6294000000000001 0.6600414273429763 0.6600405873521242 -1.2101584775658925e-06 -0.07426165255253525 -0.6295 0.6600543178506717 0.6600535012361648 -1.206443659335088e-06 -0.07426846540180243 -0.6296 0.6600672052342222 0.6600664119181279 -1.2024947604605263e-06 -0.07427527671395114 -0.6297 0.6600800894965457 0.660079319396246 -1.1983125923487048e-06 -0.07428208648918727 -0.6298 0.6600929706405518 0.6600922236687605 -1.1938980132297772e-06 -0.07428889472771677 -0.6299000000000001 0.6601058486691409 0.6601051247339214 -1.1892519281297975e-06 -0.0742957014297456 -0.63 0.6601187235852044 0.6601180225899879 -1.184375288509898e-06 -0.07430250659547978 -0.6301 0.6601315953916236 0.6601309172352288 -1.179269092238533e-06 -0.07430931022512532 -0.6302000000000001 0.6601444640912703 0.6601438086679242 -1.173934383424946e-06 -0.07431611231888846 -0.6303000000000001 0.6601573296870042 0.6601566968863638 -1.1683722521138584e-06 -0.07432291287697528 -0.6304000000000001 0.6601701921816752 0.660169581888849 -1.162583833952402e-06 -0.07432971189959202 -0.6305 0.6601830515781208 0.6601824636736926 -1.1565703102178748e-06 -0.07433650938694496 -0.6306 0.6601959078791668 0.6601953422392199 -1.150332907401408e-06 -0.07434330533924043 -0.6307 0.6602087610876259 0.6602082175837682 -1.1438728969859202e-06 -0.07435009975668472 -0.6308 0.6602216112062984 0.6602210897056884 -1.1371915952795852e-06 -0.07435689263948429 -0.6309000000000001 0.6602344582379708 0.6602339586033443 -1.1302903630272532e-06 -0.07436368398784561 -0.631 0.6602473021854158 0.660246824275114 -1.1231706053549395e-06 -0.07437047380197519 -0.6311 0.6602601430513922 0.6602596867193897 -1.115833771131447e-06 -0.0743772620820796 -0.6312000000000001 0.6602729808386434 0.6602725459345784 -1.108281352996121e-06 -0.07438404882836545 -0.6313000000000001 0.6602858155498975 0.6602854019191025 -1.1005148868037384e-06 -0.07439083404103934 -0.6314000000000001 0.6602986471878678 0.6602982546713996 -1.0925359515967514e-06 -0.074397617720308 -0.6315 0.6603114757552504 0.6603111041899241 -1.0843461690501766e-06 -0.07440439986637819 -0.6316 0.6603243012547261 0.6603239504731462 -1.0759472033328166e-06 -0.07441118047945672 -0.6317 0.6603371236889578 0.6603367935195532 -1.067340760552149e-06 -0.07441795955975042 -0.6318 0.6603499430605917 0.6603496333276502 -1.0585285886155482e-06 -0.07442473710746618 -0.6319000000000001 0.6603627593722556 0.6603624698959591 -1.0495124767861963e-06 -0.07443151312281092 -0.632 0.6603755726265598 0.6603753032230213 -1.040294255294505e-06 -0.07443828760599165 -0.6321 0.6603883828260956 0.660388133307396 -1.0308757950883152e-06 -0.07444506055721546 -0.6322000000000001 0.6604011899734354 0.6604009601476614 -1.0212590072500305e-06 -0.07445183197668942 -0.6323000000000001 0.6604139940711322 0.6604137837424147 -1.0114458428300832e-06 -0.07445860186462058 -0.6324000000000001 0.6604267951217191 0.6604266040902738 -1.001438292430601e-06 -0.07446537022121617 -0.6325 0.6604395931277094 0.6604394211898763 -9.912383854282503e-07 -0.07447213704668341 -0.6326 0.660452388091595 0.6604522350398805 -9.808481902240374e-07 -0.0744789023412296 -0.6327 0.6604651800158479 0.6604650456389656 -9.702698134383958e-07 -0.07448566610506203 -0.6328 0.6604779689029181 0.6604778529858322 -9.595053992728086e-07 -0.07449242833838811 -0.6329000000000001 0.6604907547552339 0.6604906570792022 -9.485571295375639e-07 -0.07449918904141518 -0.633 0.6605035375752017 0.6605034579178204 -9.374272229578651e-07 -0.07450594821435082 -0.6331 0.6605163173652054 0.6605162555004533 -9.26117934674231e-07 -0.07451270585740245 -0.6332000000000001 0.6605290941276063 0.6605290498258913 -9.146315560482066e-07 -0.07451946197077775 -0.6333000000000001 0.6605418678647414 0.6605418408929464 -9.029704139129624e-07 -0.07452621655468417 -0.6334000000000001 0.6605546385789256 0.6605546287004557 -8.911368703234945e-07 -0.07453296960932947 -0.6335 0.660567406272449 0.660567413247279 -8.791333219737574e-07 -0.07453972113492131 -0.6336 0.6605801709475779 0.6605801945323013 -8.669621995999188e-07 -0.07454647113166744 -0.6337 0.6605929326065536 0.6605929725544315 -8.546259677444379e-07 -0.07455321959977568 -0.6338 0.6606056912515931 0.6606057473126037 -8.421271241038086e-07 -0.07455996653945385 -0.6339000000000001 0.6606184468848875 0.6606185188057774 -8.294681989873265e-07 -0.07456671195090989 -0.634 0.6606311995086024 0.6606312870329373 -8.166517549978991e-07 -0.07457345583435164 -0.6341 0.6606439491248779 0.6606440519930944 -8.036803863104014e-07 -0.07458019818998717 -0.6342000000000001 0.6606566957358275 0.6606568136852855 -7.905567182553419e-07 -0.07458693901802443 -0.6343000000000001 0.6606694393435385 0.6606695721085742 -7.772834067359957e-07 -0.07459367831867157 -0.6344000000000001 0.6606821799500712 0.6606823272620512 -7.638631377149263e-07 -0.0746004160921367 -0.6345 0.660694917557459 0.6606950791448337 -7.502986266727518e-07 -0.07460715233862801 -0.6346 0.6607076521677072 0.6607078277560667 -7.365926181779336e-07 -0.07461388705835366 -0.6347 0.6607203837827942 0.6607205730949227 -7.227478850818647e-07 -0.07462062025152193 -0.6348 0.6607331124046698 0.6607333151606023 -7.087672281719248e-07 -0.07462735191834113 -0.6349000000000001 0.6607458380352558 0.6607460539523348 -6.946534755053468e-07 -0.07463408205901965 -0.635 0.6607585606764456 0.6607587894693772 -6.804094818402273e-07 -0.07464081067376585 -0.6351 0.6607712803301036 0.6607715217110159 -6.660381280942929e-07 -0.07464753776278821 -0.6352000000000001 0.6607839969980649 0.6607842506765662 -6.515423208591775e-07 -0.0746542633262952 -0.6353000000000001 0.660796710682136 0.6607969763653729 -6.369249915816333e-07 -0.07466098736449542 -0.6354000000000001 0.660809421384093 0.6608096987768101 -6.221890961888299e-07 -0.0746677098775974 -0.6355 0.6608221291056824 0.6608224179102817 -6.073376143250764e-07 -0.07467443086580974 -0.6356 0.6608348338486211 0.660835133765222 -5.92373548907732e-07 -0.0746811503293412 -0.6357 0.6608475356145952 0.6608478463410952 -5.772999253639277e-07 -0.07468786826840047 -0.6358 0.6608602344052608 0.6608605556373963 -5.621197911864773e-07 -0.07469458468319636 -0.6359000000000001 0.6608729302222425 0.6608732616536507 -5.468362151705985e-07 -0.0747012995739376 -0.636 0.6608856230671344 0.6608859643894149 -5.314522869698246e-07 -0.0747080129408331 -0.6361 0.6608983129415 0.6608986638442766 -5.159711161939473e-07 -0.07471472478409179 -0.6362000000000001 0.6609109998468707 0.6609113600178549 -5.00395831978806e-07 -0.07472143510392262 -0.6363000000000001 0.6609236837847468 0.6609240529098002 -4.847295824728093e-07 -0.07472814390053456 -0.6364000000000001 0.6609363647565963 0.6609367425197945 -4.6897553389324553e-07 -0.07473485117413668 -0.6365 0.660949042763856 0.6609494288475525 -4.53136870123827e-07 -0.0747415569249381 -0.6366 0.6609617178079303 0.6609621118928201 -4.372167919514114e-07 -0.07474826115314795 -0.6367 0.6609743898901912 0.6609747916553756 -4.212185165108906e-07 -0.07475496385897537 -0.6368 0.6609870590119787 0.6609874681350301 -4.051452765496677e-07 -0.07476166504262963 -0.6369000000000001 0.6609997251745996 0.6610001413316267 -3.8900031987948447e-07 -0.07476836470431995 -0.637 0.6610123883793289 0.6610128112450416 -3.7278690858538743e-07 -0.07477506284425571 -0.6371 0.661025048627408 0.6610254778751838 -3.565083184081663e-07 -0.07478175946264624 -0.6372000000000001 0.6610377059200456 0.6610381412219953 -3.401678382447537e-07 -0.07478845455970096 -0.6373000000000001 0.6610503602584175 0.661050801285451 -3.2376876921841324e-07 -0.07479514813562937 -0.6374000000000001 0.6610630116436657 0.661063458065559 -3.073144242138337e-07 -0.07480184019064091 -0.6375 0.6610756600768994 0.6610761115623611 -2.908081271346674e-07 -0.07480853072494519 -0.6376000000000001 0.6610883055591943 0.6610887617759319 -2.742532122235186e-07 -0.07481521973875167 -0.6377 0.661100948091592 0.6611014087063806 -2.576530234235652e-07 -0.07482190723227015 -0.6378 0.6611135876751011 0.6611140523538489 -2.4101091366385274e-07 -0.07482859320571021 -0.6379000000000001 0.661126224310696 0.6611266927185131 -2.243302442070383e-07 -0.0748352776592816 -0.638 0.6611388579993177 0.6611393298005827 -2.0761438397631782e-07 -0.0748419605931941 -0.6381 0.661151488741873 0.6611519636003015 -1.9086670886153678e-07 -0.07484864200765755 -0.6382000000000001 0.661164116539235 0.6611645941179471 -1.740906010391785e-07 -0.07485532190288179 -0.6383000000000001 0.6611767413922425 0.661177221353831 -1.5728944828194424e-07 -0.07486200027907668 -0.6384000000000001 0.6611893633017003 0.6611898453082988 -1.4046664330302772e-07 -0.07486867713645227 -0.6385 0.6612019822683792 0.6612024659817304 -1.236255830240618e-07 -0.07487535247521845 -0.6386000000000001 0.6612145982930158 0.6612150833745395 -1.0676966794367915e-07 -0.07488202629558531 -0.6387 0.6612272113763124 0.6612276974871745 -8.99023014158673e-08 -0.07488869859776291 -0.6388 0.6612398215189371 0.6612403083201175 -7.302688895954867e-08 -0.07489536938196142 -0.6389000000000001 0.6612524287215242 0.6612529158738852 -5.6146837588109955e-08 -0.074902038648391 -0.639 0.6612650329846733 0.6612655201490285 -3.92655551170306e-08 -0.07490870639726192 -0.6391 0.6612776343089499 0.661278121146132 -2.2386449473896577e-08 -0.07491537262878435 -0.6392 0.6612902326948848 0.6612907188658154 -5.5129280055951635e-09 -0.07492203734316864 -0.6393000000000001 0.6613028281429753 0.6613033133087316 1.1351603205166094e-08 -0.07492870054062511 -0.6394000000000001 0.661315420653684 0.6613159044755688 2.82037400274604e-08 -0.07493536222136418 -0.6395 0.6613280102274396 0.6613284923670486 4.5040080973862695e-08 -0.07494202238559629 -0.6396000000000001 0.6613405968646364 0.661341076983927 6.185722788674963e-08 -0.07494868103353192 -0.6397 0.6613531805656345 0.6613536583269946 7.865178661484173e-08 -0.07495533816538157 -0.6398 0.6613657613307604 0.6613662363970754 9.542036771836848e-08 -0.07496199378135589 -0.6399000000000001 0.6613783391603059 0.6613788111950276 1.1215958712826324e-07 -0.07496864788166545 -0.64 0.6613909140545291 0.6613913827217438 1.288660668660735e-07 -0.07497530046652089 -0.6401 0.6614034860136544 0.66140395097815 1.4553643569448216e-07 -0.07498195153613293 -0.6402 0.6614160550378722 0.661416515965206 1.6216732980772752e-07 -0.07498860109071233 -0.6403000000000001 0.6614286211273389 0.661429077683906 1.7875539351161485e-07 -0.07499524913046988 -0.6404000000000001 0.6614411842821777 0.6614416361352771 1.9529727988965018e-07 -0.07500189565561645 -0.6405 0.6614537445024775 0.6614541913203804 2.1178965152468532e-07 -0.07500854066636284 -0.6406000000000001 0.6614663017882945 0.6614667432403107 2.2822918113035717e-07 -0.07501518416292002 -0.6407 0.6614788561396507 0.6614792918961956 2.446125522276299e-07 -0.07502182614549895 -0.6408 0.6614914075565355 0.6614918372891965 2.6093645982133706e-07 -0.07502846661431063 -0.6409000000000001 0.6615039560389048 0.6615043794205074 2.7719761107325436e-07 -0.07503510556956611 -0.641 0.6615165015866815 0.6615169182913561 2.9339272591966115e-07 -0.07504174301147654 -0.6411 0.6615290441997559 0.6615294539030024 3.095185378554355e-07 -0.07504837894025296 -0.6412 0.661541583877985 0.6615419862567397 3.255717945099823e-07 -0.07505501335610666 -0.6413000000000001 0.6615541206211935 0.6615545153538934 3.415492582370394e-07 -0.0750616462592488 -0.6414000000000001 0.6615666544291737 0.6615670411958215 3.574477068779558e-07 -0.07506827764989067 -0.6415 0.6615791853016856 0.6615795637839146 3.7326393444170325e-07 -0.07507490752824361 -0.6416000000000001 0.6615917132384566 0.661592083119595 3.889947516461101e-07 -0.07508153589451892 -0.6417 0.6616042382391827 0.6616045992043171 4.046369865423616e-07 -0.07508816274892802 -0.6418 0.6616167603035279 0.6616171120395675 4.201874853060339e-07 -0.0750947880916824 -0.6419000000000001 0.6616292794311243 0.6616296216268637 4.3564311269506106e-07 -0.07510141192299347 -0.642 0.661641795621573 0.6616421279677551 4.5100075291015784e-07 -0.07510803424307283 -0.6421 0.6616543088744439 0.661654631063822 4.662573100250311e-07 -0.075114655052132 -0.6422 0.6616668191892754 0.6616671309166762 4.814097086941471e-07 -0.07512127435038263 -0.6423000000000001 0.6616793265655756 0.6616796275279597 4.964548946662095e-07 -0.07512789213803636 -0.6424000000000001 0.6616918310028216 0.6616921208993456 5.113898356862157e-07 -0.0751345084153049 -0.6425 0.6617043325004606 0.661704611032537 5.262115217036234e-07 -0.07514112318240002 -0.6426000000000001 0.6617168310579089 0.661717097929267 5.40916965857674e-07 -0.07514773643953344 -0.6427 0.6617293266745539 0.6617295815912994 5.555032048382147e-07 -0.07515434818691703 -0.6428 0.6617418193497525 0.6617420620204266 5.699672995934657e-07 -0.07516095842476268 -0.6429000000000001 0.6617543090828325 0.6617545392184712 5.843063359545209e-07 -0.0751675671532823 -0.643 0.6617667958730926 0.6617670131872844 5.985174250100478e-07 -0.07517417437268781 -0.6431 0.6617792797198024 0.6617794839287467 6.125977039667108e-07 -0.0751807800831912 -0.6432 0.6617917606222028 0.6617919514447673 6.265443366348933e-07 -0.07518738428500454 -0.6433000000000001 0.6618042385795065 0.6618044157372834 6.403545139282985e-07 -0.0751939869783399 -0.6434000000000001 0.6618167135908986 0.6618168768082604 6.540254543913049e-07 -0.07520058816340947 -0.6435 0.6618291856555352 0.6618293346596915 6.675544049900006e-07 -0.0752071878404253 -0.6436000000000001 0.6618416547725459 0.6618417892935978 6.80938641514639e-07 -0.07521378600959971 -0.6437 0.6618541209410324 0.661854240712027 6.941754690653612e-07 -0.07522038267114489 -0.6438 0.6618665841600699 0.6618666889170544 7.072622227599634e-07 -0.07522697782527321 -0.6439000000000001 0.6618790444287067 0.6618791339107812 7.201962681502305e-07 -0.0752335714721969 -0.644 0.661891501745965 0.6618915756953355 7.329750017215364e-07 -0.07524016361212843 -0.6441 0.6619039561108409 0.6619040142728712 7.455958516422445e-07 -0.07524675424528017 -0.6442 0.6619164075223043 0.6619164496455676 7.58056278082897e-07 -0.07525334337186462 -0.6443000000000001 0.6619288559793006 0.6619288818156297 7.70353773715815e-07 -0.07525993099209424 -0.6444000000000001 0.6619413014807498 0.6619413107852878 7.824858643812327e-07 -0.07526651710618164 -0.6445 0.6619537440255469 0.6619537365567962 7.94450109406486e-07 -0.07527310171433936 -0.6446000000000001 0.6619661836125627 0.6619661591324343 8.062441022443911e-07 -0.07527968481678003 -0.6447 0.6619786202406442 0.6619785785145045 8.178654709589672e-07 -0.07528626641371634 -0.6448 0.6619910539086145 0.6619909947053337 8.293118784752362e-07 -0.07529284650536097 -0.6449000000000001 0.6620034846152735 0.6620034077072721 8.405810233702571e-07 -0.07529942509192672 -0.645 0.6620159123593979 0.662015817522692 8.516706402617036e-07 -0.07530600217362636 -0.6451 0.6620283371397424 0.6620282241539897 8.625785000160313e-07 -0.07531257775067275 -0.6452 0.662040758955039 0.6620406276035823 8.733024104701226e-07 -0.07531915182327878 -0.6453000000000001 0.6620531778039979 0.6620530278739096 8.838402168198645e-07 -0.07532572439165737 -0.6454000000000001 0.6620655936853076 0.6620654249674327 8.941898019532157e-07 -0.07533229545602148 -0.6455 0.6620780065976359 0.662077818886633 9.043490870330739e-07 -0.07533886501658406 -0.6456000000000001 0.66209041653963 0.6620902096340139 9.143160318303423e-07 -0.07534543307355819 -0.6457 0.6621028235099164 0.662102597212098 9.240886351125077e-07 -0.07535199962715698 -0.6458 0.6621152275071016 0.6621149816234284 9.336649350599746e-07 -0.07535856467759353 -0.6459000000000001 0.662127628529773 0.662127362870568 9.430430096268871e-07 -0.07536512822508101 -0.646 0.662140026576499 0.6621397409560978 9.522209770407297e-07 -0.0753716902698327 -0.6461 0.6621524216458283 0.6621521158826182 9.611969961631495e-07 -0.07537825081206175 -0.6462 0.6621648137362925 0.6621644876527477 9.69969266961801e-07 -0.07538480985198154 -0.6463000000000001 0.6621772028464048 0.6621768562691227 9.785360304270796e-07 -0.0753913673898053 -0.6464000000000001 0.6621895889746606 0.662189221734397 9.868955694047887e-07 -0.07539792342574647 -0.6465 0.6622019721195389 0.6622015840512419 9.950462087904288e-07 -0.0754044779600185 -0.6466000000000001 0.6622143522795017 0.6622139432223444 1.0029863157789976e-06 -0.07541103099283482 -0.6467 0.6622267294529947 0.6622262992504083 1.0107143003368346e-06 -0.0754175825244089 -0.6468 0.6622391036384481 0.6622386521381532 1.0182286155069331e-06 -0.07542413255495432 -0.6469000000000001 0.6622514748342764 0.6622510018883139 1.025527757630984e-06 -0.0754306810846846 -0.647 0.6622638430388798 0.6622633485036395 1.0326102665991765e-06 -0.0754372281138134 -0.6471 0.6622762082506434 0.6622756919868944 1.0394747263497983e-06 -0.07544377364255435 -0.6472 0.6622885704679389 0.6622880323408566 1.0461197650080134e-06 -0.07545031767112119 -0.6473000000000001 0.662300929689124 0.6623003695683178 1.0525440552744403e-06 -0.07545686019972764 -0.6474000000000001 0.6623132859125433 0.6623127036720825 1.0587463145084186e-06 -0.07546340122858744 -0.6475 0.6623256391365293 0.6623250346549681 1.0647253051720984e-06 -0.07546994075791451 -0.6476000000000001 0.6623379893594017 0.6623373625198039 1.0704798351079958e-06 -0.07547647878792263 -0.6477 0.6623503365794684 0.6623496872694314 1.0760087574557264e-06 -0.07548301531882574 -0.6478 0.6623626807950265 0.6623620089067033 1.0813109712348723e-06 -0.07548955035083782 -0.6479000000000001 0.6623750220043618 0.6623743274344824 1.0863854215670266e-06 -0.0754960838841728 -0.648 0.66238736020575 0.6623866428556429 1.0912310995925267e-06 -0.07550261591904472 -0.6481 0.6623996953974568 0.662398955173068 1.0958470428590328e-06 -0.07550914645566764 -0.6482 0.6624120275777385 0.6624112643896505 1.1002323355713273e-06 -0.07551567549425563 -0.6483000000000001 0.6624243567448427 0.6624235705082924 1.1043861087023377e-06 -0.07552220303502287 -0.6484000000000001 0.6624366828970079 0.6624358735319041 1.1083075401874254e-06 -0.07552872907818353 -0.6485 0.6624490060324653 0.662448173463404 1.1119958550909192e-06 -0.07553525362395182 -0.6486000000000001 0.6624613261494376 0.6624604703057179 1.1154503257171378e-06 -0.07554177667254201 -0.6487 0.6624736432461416 0.6624727640617787 1.1186702717214114e-06 -0.07554829822416842 -0.6488 0.6624859573207866 0.662485054734526 1.1216550604986608e-06 -0.07555481827904538 -0.6489000000000001 0.6624982683715765 0.6624973423269056 1.1244041068780852e-06 -0.07556133683738729 -0.649 0.6625105763967092 0.6625096268418682 1.1269168737892965e-06 -0.07556785389940857 -0.6491 0.6625228813943771 0.6625219082823703 1.129192871873741e-06 -0.07557436946532364 -0.6492 0.6625351833627688 0.6625341866513728 1.1312316598455219e-06 -0.07558088353534706 -0.6493000000000001 0.662547482300068 0.6625464619518411 1.1330328445469107e-06 -0.07558739610969334 -0.6494000000000001 0.6625597782044548 0.6625587341867436 1.1345960810316136e-06 -0.07559390718857706 -0.6495 0.6625720710741068 0.6625710033590524 1.1359210724537494e-06 -0.07560041677221291 -0.6496000000000001 0.6625843609071979 0.6625832694717424 1.1370075704009164e-06 -0.0756069248608155 -0.6497 0.6625966477019001 0.6625955325277897 1.1378553747276587e-06 -0.07561343145459941 -0.6498 0.6626089314563839 0.6626077925301733 1.1384643338330225e-06 -0.07561993655377952 -0.6499000000000001 0.6626212121688183 0.6626200494818733 1.1388343444662663e-06 -0.07562644015857056 -0.65 0.6626334898373718 0.66263230338587 1.138965351893395e-06 -0.07563294226918738 -0.6501 0.6626457644602124 0.6626445542451442 1.1388573497028709e-06 -0.07563944288584479 -0.6502 0.6626580360355085 0.6626568020626766 1.1385103799166352e-06 -0.07564594200875775 -0.6503000000000001 0.6626703045614288 0.6626690468414473 1.1379245332676646e-06 -0.07565243963814117 -0.6504000000000001 0.6626825700361434 0.6626812885844345 1.137099948617104e-06 -0.07565893577420992 -0.6505 0.6626948324578245 0.6626935272946157 1.1360368135926446e-06 -0.07566543041717921 -0.6506000000000001 0.6627070918246454 0.6627057629749655 1.1347353636725899e-06 -0.07567192356726393 -0.6507000000000001 0.6627193481347833 0.662717995628456 1.1331958831295452e-06 -0.07567841522467923 -0.6508 0.6627316013864174 0.6627302252580565 1.1314187044197954e-06 -0.07568490538964025 -0.6509000000000001 0.6627438515777312 0.662742451866732 1.1294042080445266e-06 -0.07569139406236214 -0.651 0.6627560987069123 0.6627546754574438 1.1271528226053373e-06 -0.07569788124306008 -0.6511 0.6627683427721525 0.6627668960331488 1.124665024804239e-06 -0.07570436693194936 -0.6512 0.6627805837716492 0.6627791135967983 1.1219413393048772e-06 -0.07571085112924525 -0.6513000000000001 0.6627928217036047 0.6627913281513385 1.1189823385937547e-06 -0.07571733383516308 -0.6514000000000001 0.6628050565662278 0.6628035396997092 1.1157886427304309e-06 -0.07572381504991821 -0.6515 0.6628172883577339 0.6628157482448437 1.112360919514055e-06 -0.07573029477372605 -0.6516000000000001 0.6628295170763447 0.6628279537896684 1.108699884039277e-06 -0.07573677300680197 -0.6517000000000001 0.6628417427202903 0.662840156337102 1.1048062989182927e-06 -0.07574324974936149 -0.6518 0.6628539652878079 0.662852355890056 1.1006809736702206e-06 -0.07574972500162017 -0.6519000000000001 0.6628661847771438 0.6628645524514324 1.0963247648043684e-06 -0.07575619876379353 -0.652 0.6628784011865526 0.6628767460241249 1.0917385758479892e-06 -0.07576267103609714 -0.6521 0.6628906145142986 0.6628889366110178 1.0869233566801473e-06 -0.07576914181874664 -0.6522 0.662902824758656 0.6629011242149853 1.0818801038925407e-06 -0.07577561111195773 -0.6523000000000001 0.6629150319179092 0.6629133088388914 1.0766098601788787e-06 -0.0757820789159461 -0.6524000000000001 0.6629272359903533 0.6629254904855892 1.0711137140573257e-06 -0.07578854523092746 -0.6525 0.6629394369742946 0.662937669157921 1.065392800037035e-06 -0.07579501005711765 -0.6526000000000001 0.6629516348680509 0.662949844858717 1.059448298201815e-06 -0.07580147339473246 -0.6527000000000001 0.6629638296699527 0.6629620175907952 1.0532814338215513e-06 -0.07580793524398775 -0.6528 0.6629760213783427 0.6629741873569611 1.0468934772689398e-06 -0.07581439560509941 -0.6529 0.6629882099915765 0.6629863541600072 1.0402857438251978e-06 -0.0758208544782834 -0.653 0.6630003955080237 0.6629985180027125 1.0334595932082191e-06 -0.0758273118637557 -0.6531 0.6630125779260674 0.6630106788878417 1.0264164294337963e-06 -0.07583376776173226 -0.6532 0.6630247572441053 0.6630228368181454 1.0191577005380648e-06 -0.0758402221724292 -0.6533000000000001 0.6630369334605499 0.6630349917963594 1.0116848981611692e-06 -0.07584667509606258 -0.6534000000000001 0.6630491065738289 0.6630471438252037 1.0039995573807303e-06 -0.0758531265328485 -0.6535 0.6630612765823856 0.6630592929073832 9.961032563787775e-07 -0.07585957648300312 -0.6536000000000001 0.6630734434846799 0.6630714390455864 9.879976160531712e-07 -0.07586602494674266 -0.6537000000000001 0.6630856072791876 0.6630835822424852 9.796842995735133e-07 -0.0758724719242834 -0.6538 0.6630977679644021 0.6630957225007343 9.711650124366589e-07 -0.07587891741584153 -0.6539 0.6631099255388342 0.6631078598229709 9.62441501717315e-07 -0.07588536142163342 -0.654 0.6631220800010118 0.6631199942118152 9.535155558459962e-07 -0.0758918039418754 -0.6541 0.6631342313494821 0.6631321256698681 9.443890043869807e-07 -0.07589824497678391 -0.6542 0.6631463795828099 0.6631442541997119 9.350637175387089e-07 -0.07590468452657524 -0.6543000000000001 0.6631585246995799 0.6631563798039105 9.255416056064281e-07 -0.07591112259146598 -0.6544000000000001 0.663170666698396 0.6631685024850077 9.158246188634145e-07 -0.07591755917167257 -0.6545 0.6631828055778816 0.6631806222455277 9.059147471623952e-07 -0.07592399426741153 -0.6546000000000001 0.6631949413366809 0.663192739087974 8.958140192971698e-07 -0.07593042787889946 -0.6547000000000001 0.6632070739734587 0.6632048530148302 8.855245025585212e-07 -0.07593686000635301 -0.6548 0.6632192034869006 0.6632169640285579 8.75048302928505e-07 -0.07594329064998875 -0.6549 0.6632313298757138 0.6632290721315981 8.643875638036924e-07 -0.07594971981002344 -0.655 0.6632434531386271 0.6632411773263692 8.535444661617042e-07 -0.07595614748667374 -0.6551 0.6632555732743916 0.6632532796152679 8.425212277562988e-07 -0.07596257368015641 -0.6552 0.6632676902817811 0.6632653790006682 8.313201028675721e-07 -0.07596899839068828 -0.6553000000000001 0.6632798041595924 0.6632774754849208 8.199433818856239e-07 -0.07597542161848617 -0.6554000000000001 0.6632919149066451 0.6632895690703535 8.083933906166685e-07 -0.0759818433637669 -0.6555 0.6633040225217829 0.6633016597592705 7.966724900748678e-07 -0.07598826362674746 -0.6556000000000001 0.6633161270038732 0.6633137475539518 7.847830757745644e-07 -0.07599468240764473 -0.6557000000000001 0.6633282283518078 0.663325832456653 7.72727577411092e-07 -0.0760010997066757 -0.6558 0.6633403265645035 0.663337914469605 7.605084582779087e-07 -0.07600751552405739 -0.6559 0.6633524216409015 0.6633499935950136 7.481282147253632e-07 -0.07601392986000685 -0.656 0.6633645135799688 0.6633620698350595 7.355893757998722e-07 -0.07602034271474116 -0.6561 0.6633766023806982 0.6633741431918975 7.2289450261942e-07 -0.07602675408847745 -0.6562 0.6633886880421079 0.6633862136676565 7.10046187762936e-07 -0.07603316398143292 -0.6563000000000001 0.6634007705632429 0.6633982812644389 6.970470550343721e-07 -0.0760395723938247 -0.6564000000000001 0.6634128499431746 0.6634103459843207 6.838997586994244e-07 -0.07604597932587007 -0.6565 0.6634249261810015 0.6634224078293505 6.70606982916544e-07 -0.07605238477778627 -0.6566000000000001 0.6634369992758491 0.66343446680155 6.571714412512142e-07 -0.07605878874979062 -0.6567000000000001 0.6634490692268704 0.6634465229029133 6.435958762457394e-07 -0.07606519124210046 -0.6568 0.6634611360332464 0.6634585761354069 6.298830587253557e-07 -0.07607159225493312 -0.6569 0.6634731996941863 0.663470626500969 6.160357872431188e-07 -0.07607799178850613 -0.657 0.6634852602089273 0.663482674001509 6.020568876080601e-07 -0.07608438984303684 -0.6571 0.6634973175767354 0.663494718638908 5.879492120802743e-07 -0.07609078641874277 -0.6572 0.6635093717969056 0.6635067604150183 5.737156390378528e-07 -0.07609718151584144 -0.6573000000000001 0.6635214228687618 0.663518799331663 5.593590722968722e-07 -0.07610357513455039 -0.6574000000000001 0.6635334707916578 0.6635308353906355 5.44882440584038e-07 -0.07610996727508726 -0.6575 0.6635455155649763 0.6635428685936997 5.302886967734066e-07 -0.07611635793766965 -0.6576000000000001 0.6635575571881307 0.6635548989425895 5.15580817442296e-07 -0.07612274712251524 -0.6577000000000001 0.6635695956605638 0.6635669264390086 5.007618021912741e-07 -0.07612913482984168 -0.6578 0.6635816309817494 0.6635789510846304 4.858346731306806e-07 -0.07613552105986675 -0.6579 0.6635936631511915 0.6635909728810977 4.7080247406183773e-07 -0.0761419058128082 -0.658 0.663605692168425 0.6636029918300222 4.5566827008847177e-07 -0.07614828908888387 -0.6581 0.6636177180330158 0.6636150079329851 4.404351468534351e-07 -0.0761546708883116 -0.6582 0.6636297407445615 0.6636270211915358 4.251062099558389e-07 -0.07616105121130927 -0.6583000000000001 0.6636417603026901 0.6636390316071923 4.0968458431267507e-07 -0.07616743005809473 -0.6584000000000001 0.6636537767070623 0.6636510391814414 3.9417341356207114e-07 -0.07617380742888603 -0.6585 0.6636657899573697 0.6636630439157376 3.785758592583788e-07 -0.07618018332390109 -0.6586000000000001 0.6636778000533363 0.6636750458115036 3.628951004974734e-07 -0.07618655774335796 -0.6587000000000001 0.6636898069947184 0.66368704487013 3.4713433305633146e-07 -0.07619293068747467 -0.6588 0.6637018107813042 0.6636990410929748 3.312967688517965e-07 -0.0761993021564693 -0.6589 0.6637138114129149 0.6637110344813637 3.1538563513566764e-07 -0.07620567215056002 -0.659 0.6637258088894036 0.6637230250365899 2.9940417409224374e-07 -0.07621204066996498 -0.6591 0.6637378032106569 0.6637350127599135 2.8335564194320595e-07 -0.07621840771490239 -0.6592 0.663749794376594 0.6637469976525617 2.67243308413323e-07 -0.07622477328559044 -0.6593000000000001 0.6637617823871671 0.6637589797157287 2.5107045602962286e-07 -0.07623113738224742 -0.6594000000000001 0.6637737672423614 0.6637709589505754 2.3484037941362557e-07 -0.07623750000509161 -0.6595 0.6637857489421957 0.6637829353582294 2.1855638470541505e-07 -0.07624386115434137 -0.6596000000000001 0.6637977274867222 0.6637949089397852 2.022217887795441e-07 -0.07625022083021507 -0.6597000000000001 0.6638097028760264 0.6638068796963035 1.8583991866216731e-07 -0.07625657903293113 -0.6598 0.6638216751102274 0.6638188476288113 1.6941411078164048e-07 -0.07626293576270797 -0.6599 0.6638336441894783 0.6638308127383018 1.529477103509591e-07 -0.07626929101976407 -0.66 0.6638456101139655 0.6638427750257347 1.3644407064611341e-07 -0.07627564480431794 -0.6601 0.6638575728839097 0.6638547344920356 1.1990655235730174e-07 -0.07628199711658812 -0.6602 0.6638695324995653 0.6638666911380962 1.0333852285340783e-07 -0.07628834795679319 -0.6603000000000001 0.6638814889612206 0.663878644964774 8.674335552627532e-08 -0.07629469732515176 -0.6604000000000001 0.6638934422691982 0.6638905959728927 7.012442913151284e-08 -0.0763010452218825 -0.6605 0.6639053924238546 0.663902544163242 5.348512704429764e-08 -0.07630739164720407 -0.6606000000000001 0.6639173394255806 0.663914489536577 3.682883660191538e-08 -0.07631373660133521 -0.6607000000000001 0.6639292832748009 0.6639264320936186 2.015894842548327e-08 -0.07632008008449467 -0.6608 0.6639412239719751 0.6639383718350538 3.478855715652318e-09 -0.07632642209690121 -0.6609 0.663953161517596 0.6639503087615352 -1.3208046457761913e-08 -0.0763327626387737 -0.661 0.6639650959121914 0.6639622428736809 -2.989836181410688e-08 -0.07633910171033093 -0.6611 0.6639770271563231 0.6639741741720749 -4.658869357464755e-08 -0.07634543931179183 -0.6612 0.6639889552505873 0.663986102657267 -6.327564514171068e-08 -0.07635177544337532 -0.6613000000000001 0.6640008801956141 0.6639980283297727 -7.995582080189828e-08 -0.07635811010530036 -0.6614000000000001 0.6640128019920682 0.664009951190073 -9.662582641217082e-08 -0.07636444329778595 -0.6615 0.6640247206406488 0.6640218712386148 -1.1328227008354508e-07 -0.07637077502105108 -0.6616000000000001 0.6640366361420883 0.664033788475811 -1.2992176288278978e-07 -0.07637710527531487 -0.6617000000000001 0.664048548497154 0.6640457029020397 -1.4654091952739923e-07 -0.07638343406079634 -0.6618 0.6640604577066471 0.6640576145176456 -1.631363590604007e-07 -0.07638976137771465 -0.6619 0.6640723637714033 0.6640695233229384 -1.7970470553990703e-07 -0.07639608722628899 -0.662 0.6640842666922917 0.6640814293181948 -1.9624258874167966e-07 -0.0764024116067385 -0.6621 0.6640961664702154 0.6640933325036567 -2.127466448252624e-07 -0.07640873451928246 -0.6622 0.6641080631061118 0.664105232879532 -2.292135170382792e-07 -0.07641505596414006 -0.6623000000000001 0.664119956600952 0.6641171304459957 -2.456398563895068e-07 -0.07642137594153066 -0.6624000000000001 0.6641318469557408 0.6641290252031883 -2.6202232232888645e-07 -0.07642769445167359 -0.6625 0.6641437341715162 0.6641409171512165 -2.7835758343447425e-07 -0.07643401149478816 -0.6626000000000001 0.6641556182493503 0.664152806290154 -2.946423180993918e-07 -0.07644032707109383 -0.6627000000000001 0.6641674991903487 0.6641646926200405 -3.108732151702043e-07 -0.07644664118081002 -0.6628000000000001 0.6641793769956499 0.6641765761408825 -3.2704697468244337e-07 -0.07645295382415616 -0.6629 0.6641912516664257 0.6641884568526534 -3.4316030847469925e-07 -0.07645926500135176 -0.663 0.6642031232038814 0.6642003347552934 -3.592099408894489e-07 -0.07646557471261639 -0.6631 0.6642149916092549 0.6642122098487095 -3.751926094322511e-07 -0.07647188295816959 -0.6632 0.6642268568838168 0.664224082132776 -3.9110506545175783e-07 -0.0764781897382309 -0.6633000000000001 0.6642387190288708 0.6642359516073344 -4.069440747850317e-07 -0.07648449505302002 -0.6634000000000001 0.6642505780457527 0.6642478182721937 -4.2270641840286283e-07 -0.07649079890275659 -0.6635 0.6642624339358312 0.6642596821271306 -4.383888930759028e-07 -0.07649710128766031 -0.6636 0.6642742867005068 0.6642715431718894 -4.5398831204079837e-07 -0.07650340220795096 -0.6637000000000001 0.6642861363412121 0.664283401406182 -4.6950150564550874e-07 -0.07650970166384818 -0.6638000000000001 0.6642979828594119 0.6642952568296893 -4.849253220085004e-07 -0.07651599965557188 -0.6639 0.664309826256602 0.6643071094420593 -5.002566276085529e-07 -0.07652229618334183 -0.664 0.6643216665343106 0.6643189592429093 -5.154923080202822e-07 -0.07652859124737793 -0.6641 0.6643335036940962 0.664330806231825 -5.306292684137404e-07 -0.0765348848479 -0.6642 0.6643453377375496 0.6643426504083612 -5.456644342760608e-07 -0.07654117698512806 -0.6643000000000001 0.6643571686662912 0.664354491772041 -5.605947520082033e-07 -0.07654746765928201 -0.6644000000000001 0.6643689964819731 0.6643663303223577 -5.754171895772098e-07 -0.07655375687058184 -0.6645 0.6643808211862775 0.664378166058774 -5.901287371268271e-07 -0.07656004461924765 -0.6646 0.6643926427809166 0.6643899989807216 -6.047264075187408e-07 -0.07656633090549947 -0.6647000000000001 0.6644044612676328 0.6644018290876026 -6.192072370819757e-07 -0.0765726157295573 -0.6648000000000001 0.6644162766481985 0.6644136563787898 -6.335682861263736e-07 -0.07657889909164138 -0.6649 0.664428088924415 0.6644254808536255 -6.478066394838278e-07 -0.07658518099197183 -0.665 0.6644398980981134 0.6644373025114233 -6.619194072160495e-07 -0.07659146143076877 -0.6651 0.6644517041711536 0.6644491213514676 -6.75903725155802e-07 -0.07659774040825247 -0.6652 0.6644635071454247 0.6644609373730144 -6.897567554620121e-07 -0.07660401792464325 -0.6653000000000001 0.6644753070228434 0.6644727505752904 -7.034756872581482e-07 -0.07661029398016134 -0.6654000000000001 0.6644871038053551 0.6644845609574946 -7.170577371734543e-07 -0.07661656857502702 -0.6655 0.6644988974949331 0.6644963685187982 -7.305001498564279e-07 -0.07662284170946068 -0.6656 0.6645106880935783 0.6645081732583442 -7.438001986270759e-07 -0.07662911338368271 -0.6657000000000001 0.6645224756033188 0.6645199751752487 -7.569551860320267e-07 -0.0766353835979135 -0.6658000000000001 0.6645342600262101 0.6645317742686004 -7.699624442192299e-07 -0.07664165235237351 -0.6659 0.6645460413643339 0.6645435705374615 -7.82819335812257e-07 -0.0766479196472832 -0.666 0.664557819619799 0.6645553639808673 -7.955232541878576e-07 -0.07665418548286312 -0.6661 0.6645695947947399 0.6645671545978276 -8.080716239616814e-07 -0.07666044985933379 -0.6662 0.6645813668913166 0.6645789423873258 -8.204619017376791e-07 -0.07666671277691581 -0.6663000000000001 0.6645931359117154 0.6645907273483199 -8.32691576510558e-07 -0.07667297423582974 -0.6664000000000001 0.664604901858147 0.664602509479743 -8.447581701376272e-07 -0.07667923423629625 -0.6665 0.6646166647328471 0.6646142887805031 -8.566592378939086e-07 -0.07668549277853604 -0.6666 0.6646284245380761 0.6646260652494838 -8.683923689301043e-07 -0.07669174986276976 -0.6667000000000001 0.6646401812761183 0.6646378388855444 -8.799551868554634e-07 -0.07669800548921818 -0.6668000000000001 0.6646519349492814 0.6646496096875205 -8.913453500986046e-07 -0.076704259658102 -0.6669 0.6646636855598975 0.6646613776542242 -9.025605525458946e-07 -0.07671051236964212 -0.667 0.6646754331103208 0.6646731427844447 -9.135985238051259e-07 -0.07671676362405928 -0.6671 0.6646871776029291 0.6646849050769482 -9.244570299271615e-07 -0.07672301342157442 -0.6672 0.6646989190401212 0.6646966645304786 -9.351338735030801e-07 -0.07672926176240837 -0.6673000000000001 0.6647106574243191 0.6647084211437579 -9.456268944274537e-07 -0.07673550864678205 -0.6674000000000001 0.6647223927579662 0.6647201749154866 -9.559339702036596e-07 -0.07674175407491649 -0.6675 0.6647341250435261 0.6647319258443436 -9.660530164989911e-07 -0.07674799804703258 -0.6676 0.6647458542834842 0.6647436739289869 -9.75981987366703e-07 -0.07675424056335135 -0.6677000000000001 0.664757580480346 0.6647554191680549 -9.85718875773367e-07 -0.07676048162409391 -0.6678000000000001 0.664769303636637 0.6647671615601651 -9.952617139874498e-07 -0.07676672122948128 -0.6679 0.6647810237549024 0.6647789011039158 -1.0046085740511579e-06 -0.07677295937973462 -0.668 0.6647927408377066 0.6647906377978856 -1.0137575680579936e-06 -0.07677919607507505 -0.6681 0.6648044548876324 0.6648023716406348 -1.0227068486801105e-06 -0.07678543131572374 -0.6682 0.6648161659072818 0.6648141026307046 -1.0314546094181143e-06 -0.0767916651019019 -0.6683000000000001 0.6648278738992741 0.6648258307666192 -1.039999084934129e-06 -0.07679789743383081 -0.6684000000000001 0.6648395788662463 0.6648375560468838 -1.0483385516346644e-06 -0.07680412831173161 -0.6685 0.6648512808108529 0.6648492784699875 -1.0564713276706161e-06 -0.07681035773582576 -0.6686 0.6648629797357645 0.6648609980344026 -1.0643957737699328e-06 -0.07681658570633451 -0.6687000000000001 0.6648746756436684 0.6648727147385846 -1.0721102929878157e-06 -0.0768228122234792 -0.6688000000000001 0.6648863685372677 0.6648844285809733 -1.0796133314561196e-06 -0.07682903728748126 -0.6689 0.664898058419281 0.664896139559993 -1.0869033785776416e-06 -0.07683526089856213 -0.669 0.6649097452924415 0.6649078476740534 -1.0939789673314326e-06 -0.07684148305694323 -0.6691 0.6649214291594969 0.6649195529215488 -1.1008386744948417e-06 -0.07684770376284596 -0.6692 0.6649331100232099 0.6649312553008601 -1.1074811211708724e-06 -0.07685392301649197 -0.6693000000000001 0.6649447878863557 0.6649429548103541 -1.113904972732671e-06 -0.07686014081810273 -0.6694000000000001 0.6649564627517234 0.6649546514483847 -1.1201089392953723e-06 -0.07686635716789984 -0.6695 0.6649681346221147 0.6649663452132928 -1.126091776049165e-06 -0.07687257206610491 -0.6696 0.6649798035003432 0.664978036103407 -1.131852283370316e-06 -0.07687878551293956 -0.6697000000000001 0.6649914693892348 0.6649897241170438 -1.1373893069877017e-06 -0.0768849975086254 -0.6698000000000001 0.6650031322916268 0.6650014092525091 -1.1427017384546545e-06 -0.07689120805338426 -0.6699 0.665014792210367 0.665013091508097 -1.1477885152322287e-06 -0.0768974171474378 -0.67 0.6650264491483135 0.6650247708820913 -1.1526486209112452e-06 -0.07690362479100771 -0.6701 0.6650381031083351 0.6650364473727661 -1.1572810854065807e-06 -0.07690983098431586 -0.6702 0.6650497540933095 0.665048120978386 -1.1616849852624789e-06 -0.07691603572758404 -0.6703000000000001 0.6650614021061236 0.665059791697206 -1.1658594437080616e-06 -0.07692223902103414 -0.6704000000000001 0.665073047149673 0.6650714595274729 -1.1698036309071291e-06 -0.07692844086488797 -0.6705 0.6650846892268611 0.6650831244674252 -1.1735167641246935e-06 -0.07693464125936748 -0.6706 0.665096328340599 0.6650947865152941 -1.1769981077269787e-06 -0.07694084020469458 -0.6707000000000001 0.6651079644938049 0.6651064456693033 -1.180246973653265e-06 -0.07694703770109129 -0.6708000000000001 0.6651195976894037 0.66511810192767 -1.183262721332623e-06 -0.07695323374877952 -0.6709 0.6651312279303263 0.6651297552886049 -1.1860447577671795e-06 -0.07695942834798136 -0.671 0.6651428552195098 0.6651414057503133 -1.188592537809674e-06 -0.0769656214989189 -0.6711 0.6651544795598958 0.6651530533109953 -1.1909055641912136e-06 -0.07697181320181416 -0.6712 0.665166100954431 0.6651646979688457 -1.192983387632296e-06 -0.07697800345688927 -0.6713000000000001 0.6651777194060662 0.6651763397220561 -1.1948256068150531e-06 -0.07698419226436644 -0.6714000000000001 0.6651893349177559 0.6651879785688132 -1.1964318688828524e-06 -0.07699037962446775 -0.6715 0.6652009474924581 0.6651996145073009 -1.1978018688851844e-06 -0.0769965655374155 -0.6716 0.6652125571331331 0.6652112475357006 -1.1989353503605304e-06 -0.0770027500034319 -0.6717000000000001 0.6652241638427441 0.6652228776521907 -1.1998321050865624e-06 -0.07700893302273917 -0.6718000000000001 0.6652357676242554 0.6652345048549482 -1.2004919733299424e-06 -0.07701511459555965 -0.6719 0.6652473684806334 0.6652461291421485 -1.2009148435687678e-06 -0.07702129472211568 -0.672 0.665258966414844 0.6652577505119666 -1.2011006530199264e-06 -0.07702747340262951 -0.6721 0.6652705614298549 0.6652693689625765 -1.2010493870839856e-06 -0.07703365063732359 -0.6722 0.6652821535286327 0.6652809844921532 -1.2007610798170365e-06 -0.07703982642642039 -0.6723000000000001 0.6652937427141437 0.6652925970988713 -1.200235813569872e-06 -0.07704600077014226 -0.6724000000000001 0.6653053289893528 0.6653042067809076 -1.1994737191545202e-06 -0.07705217366871174 -0.6725 0.6653169123572236 0.6653158135364395 -1.1984749757887325e-06 -0.07705834512235131 -0.6726 0.6653284928207172 0.665327417363647 -1.1972398110682292e-06 -0.07706451513128348 -0.6727000000000001 0.6653400703827923 0.6653390182607127 -1.1957685007724095e-06 -0.07707068369573083 -0.6728000000000001 0.6653516450464043 0.6653506162258221 -1.194061369197419e-06 -0.07707685081591593 -0.6729 0.6653632168145052 0.6653622112571644 -1.1921187886010376e-06 -0.07708301649206144 -0.673 0.6653747856900427 0.6653738033529326 -1.1899411793969694e-06 -0.07708918072438993 -0.6731 0.6653863516759604 0.6653853925113244 -1.1875290100715752e-06 -0.07709534351312416 -0.6732 0.6653979147751963 0.6653969787305427 -1.184882796906317e-06 -0.07710150485848678 -0.6733000000000001 0.665409474990683 0.6654085620087954 -1.1820031041998025e-06 -0.07710766476070056 -0.6734000000000001 0.6654210323253473 0.6654201423442969 -1.1788905436849184e-06 -0.07711382321998828 -0.6735 0.665432586782109 0.6654317197352679 -1.1755457748896525e-06 -0.07711998023657265 -0.6736 0.6654441383638817 0.6654432941799356 -1.1719695047762713e-06 -0.07712613581067657 -0.6737000000000001 0.6654556870735706 0.6654548656765353 -1.1681624873804974e-06 -0.07713228994252284 -0.6738000000000001 0.6654672329140741 0.6654664342233096 -1.1641255241168214e-06 -0.07713844263233438 -0.6739 0.6654787758882805 0.6654779998185099 -1.1598594631678782e-06 -0.07714459388033401 -0.674 0.665490315999071 0.6654895624603963 -1.1553651996509817e-06 -0.07715074368674477 -0.6741 0.6655018532493164 0.6655011221472382 -1.1506436753683236e-06 -0.07715689205178955 -0.6742 0.6655133876418778 0.6655126788773148 -1.1456958782241067e-06 -0.07716303897569135 -0.6743000000000001 0.6655249191796063 0.6655242326489155 -1.1405228426408787e-06 -0.07716918445867321 -0.6744000000000001 0.665536447865342 0.6655357834603406 -1.1351256488101313e-06 -0.07717532850095819 -0.6745 0.6655479737019139 0.6655473313099014 -1.1295054229698565e-06 -0.07718147110276935 -0.6746 0.6655594966921388 0.6655588761959208 -1.1236633366273896e-06 -0.07718761226432976 -0.6747000000000001 0.665571016838822 0.6655704181167339 -1.1176006067814548e-06 -0.07719375198586259 -0.6748000000000001 0.6655825341447562 0.6655819570706887 -1.1113184953115418e-06 -0.07719989026759103 -0.6749 0.6655940486127203 0.6655934930561459 -1.1048183090334174e-06 -0.07720602710973823 -0.675 0.6656055602454807 0.6656050260714794 -1.0981013993383026e-06 -0.07721216251252744 -0.6751 0.6656170690457887 0.6656165561150778 -1.0911691616655173e-06 -0.07721829647618189 -0.6752 0.6656285750163821 0.665628083185343 -1.084023035585746e-06 -0.07722442900092488 -0.6753000000000001 0.6656400781599832 0.6656396072806924 -1.0766645041349054e-06 -0.07723056008697965 -0.6754000000000001 0.6656515784792998 0.6656511283995585 -1.0690950938696542e-06 -0.0772366897345696 -0.6755 0.6656630759770228 0.6656626465403896 -1.0613163745065712e-06 -0.07724281794391799 -0.6756 0.665674570655828 0.6656741617016504 -1.053329958172755e-06 -0.07724894471524832 -0.6757000000000001 0.6656860625183743 0.6656856738818211 -1.0451374996001128e-06 -0.07725507004878394 -0.6758000000000001 0.6656975515673031 0.6656971830794003 -1.036740695542493e-06 -0.07726119394474834 -0.6759000000000001 0.6657090378052393 0.6657086892929026 -1.0281412844426185e-06 -0.07726731640336496 -0.676 0.6657205212347888 0.6657201925208611 -1.0193410459602426e-06 -0.07727343742485726 -0.6761 0.6657320018585398 0.6657316927618276 -1.0103418009166365e-06 -0.07727955700944879 -0.6762 0.665743479679062 0.6657431900143718 -1.001145410739479e-06 -0.07728567515736313 -0.6763000000000001 0.6657549546989057 0.6657546842770827 -9.917537769077445e-07 -0.07729179186882387 -0.6764000000000001 0.6657664269206014 0.6657661755485688 -9.82168840923947e-07 -0.07729790714405455 -0.6765 0.6657778963466607 0.6657776638274584 -9.72392583536985e-07 -0.07730402098327888 -0.6766 0.6657893629795736 0.6657891491124002 -9.624270247143851e-07 -0.07731013338672046 -0.6767000000000001 0.6658008268218104 0.6658006314020635 -9.522742229206571e-07 -0.07731624435460306 -0.6768000000000001 0.6658122878758197 0.6658121106951385 -9.419362747287163e-07 -0.07732235388715034 -0.6769000000000001 0.6658237461440288 0.6658235869903371 -9.314153147088611e-07 -0.07732846198458605 -0.677 0.6658352016288434 0.6658350602863925 -9.207135145128387e-07 -0.07733456864713396 -0.6771 0.6658466543326467 0.6658465305820609 -9.09833082901601e-07 -0.07734067387501793 -0.6772 0.6658581042577993 0.6658579978761203 -8.98776264746104e-07 -0.07734677766846175 -0.6773 0.6658695514066386 0.6658694621673715 -8.875453411799628e-07 -0.07735288002768917 -0.6774000000000001 0.6658809957814793 0.6658809234546397 -8.761426287112739e-07 -0.07735898095292422 -0.6775 0.665892437384612 0.6658923817367726 -8.645704788201591e-07 -0.07736508044439078 -0.6776 0.6659038762183034 0.6659038370126421 -8.528312775563096e-07 -0.07737117850231272 -0.6777000000000001 0.6659153122847956 0.6659152892811451 -8.409274450255078e-07 -0.07737727512691406 -0.6778000000000001 0.6659267455863062 0.6659267385412022 -8.28861434890027e-07 -0.07738337031841877 -0.6779000000000001 0.6659381761250277 0.6659381847917598 -8.166357337857644e-07 -0.07738946407705088 -0.678 0.665949603903127 0.6659496280317891 -8.04252860933663e-07 -0.07739555640303442 -0.6781 0.6659610289227453 0.6659610682602877 -7.917153675984778e-07 -0.07740164729659345 -0.6782 0.6659724511859983 0.6659725054762782 -7.790258363810088e-07 -0.07740773675795211 -0.6783 0.6659838706949748 0.6659839396788103 -7.661868811070782e-07 -0.0774138247873345 -0.6784000000000001 0.6659952874517371 0.6659953708669599 -7.53201145800575e-07 -0.07741991138496478 -0.6785 0.6660067014583203 0.6660067990398302 -7.400713045307983e-07 -0.07742599655106713 -0.6786 0.6660181127167325 0.6660182241965512 -7.268000605381575e-07 -0.07743208028586575 -0.6787000000000001 0.6660295212289542 0.6660296463362806 -7.133901459427383e-07 -0.07743816258958489 -0.6788000000000001 0.6660409269969376 0.6660410654582037 -6.998443211059246e-07 -0.07744424346244874 -0.6789000000000001 0.6660523300226078 0.6660524815615344 -6.86165373950387e-07 -0.07745032290468164 -0.679 0.6660637303078603 0.6660638946455145 -6.723561195576266e-07 -0.0774564009165079 -0.6791 0.6660751278545625 0.6660753047094146 -6.584193995018417e-07 -0.07746247749815184 -0.6792 0.666086522664553 0.6660867117525342 -6.443580812254268e-07 -0.07746855264983785 -0.6793 0.6660979147396409 0.6660981157742017 -6.301750575116172e-07 -0.07747462637179026 -0.6794000000000001 0.666109304081606 0.6661095167737756 -6.158732458738658e-07 -0.07748069866423357 -0.6795 0.6661206906921981 0.6661209147506432 -6.014555880423655e-07 -0.07748676952739218 -0.6796 0.6661320745731377 0.6661323097042224 -5.869250491452593e-07 -0.07749283896149059 -0.6797000000000001 0.6661434557261139 0.6661437016339606 -5.722846174172069e-07 -0.07749890696675318 -0.6798000000000001 0.6661548341527868 0.6661550905393363 -5.575373032279396e-07 -0.07750497354340463 -0.6799000000000001 0.666166209854785 0.6661664764198579 -5.426861387491932e-07 -0.07751103869166942 -0.68 0.6661775828337062 0.666177859275065 -5.277341771220412e-07 -0.07751710241177208 -0.6801 0.6661889530911176 0.6661892391045281 -5.126844920544382e-07 -0.07752316470393728 -0.6802 0.6662003206285548 0.6662006159078488 -4.97540177016309e-07 -0.07752922556838962 -0.6803 0.6662116854475219 0.6662119896846603 -4.823043446428033e-07 -0.07753528500535371 -0.6804000000000001 0.6662230475494914 0.6662233604346277 -4.669801261375506e-07 -0.07754134301505433 -0.6805 0.6662344069359039 0.666234728157447 -4.5157067053713806e-07 -0.07754739959771612 -0.6806 0.666245763608168 0.6662460928528469 -4.3607914421150973e-07 -0.0775534547535638 -0.6807000000000001 0.66625711756766 0.6662574545205877 -4.2050873010068823e-07 -0.07755950848282211 -0.6808000000000001 0.6662684688157244 0.6662688131604627 -4.0486262706251885e-07 -0.07756556078571589 -0.6809000000000001 0.6662798173536726 0.6662801687722972 -3.891440492828635e-07 -0.0775716116624699 -0.681 0.6662911631827835 0.6662915213559493 -3.7335622557477244e-07 -0.07757766111330901 -0.6811 0.666302506304303 0.6663028709113091 -3.5750239873316714e-07 -0.07758370913845802 -0.6812 0.6663138467194446 0.666314217438301 -3.415858248270731e-07 -0.0775897557381419 -0.6813 0.6663251844293882 0.6663255609368814 -3.2560977259593615e-07 -0.07759580091258551 -0.6814000000000001 0.6663365194352805 0.6663369014070399 -3.0957752272103845e-07 -0.07760184466201375 -0.6815 0.6663478517382351 0.6663482388487998 -2.9349236717324256e-07 -0.07760788698665162 -0.6816 0.6663591813393326 0.6663595732622174 -2.7735760855379654e-07 -0.07761392788672415 -0.6817000000000001 0.6663705082396191 0.6663709046473827 -2.6117655942126117e-07 -0.07761996736245627 -0.6818000000000001 0.6663818324401076 0.666382233004419 -2.4495254153517054e-07 -0.07762600541407305 -0.6819000000000001 0.6663931539417776 0.6663935583334837 -2.2868888529745113e-07 -0.07763204204179955 -0.682 0.6664044727455743 0.6664048806347675 -2.123889289579184e-07 -0.07763807724586089 -0.6821 0.6664157888524096 0.6664161999084951 -1.9605601800365413e-07 -0.07764411102648214 -0.6822 0.6664271022631609 0.6664275161549251 -1.7969350443042265e-07 -0.07765014338388844 -0.6823 0.6664384129786717 0.6664388293743503 -1.6330474608000634e-07 -0.07765617431830497 -0.6824000000000001 0.6664497209997513 0.666450139567097 -1.468931059220302e-07 -0.07766220382995691 -0.6825 0.6664610263271756 0.666461446733526 -1.3046195140690997e-07 -0.07766823191906946 -0.6826 0.6664723289616858 0.666472750874032 -1.1401465372859465e-07 -0.0776742585858679 -0.6827000000000001 0.6664836289039886 0.6664840519890438 -9.755458716537158e-08 -0.07768028383057746 -0.6828000000000001 0.6664949261547573 0.6664953500790245 -8.108512836949716e-08 -0.07768630765342338 -0.6829000000000001 0.6665062207146302 0.6665066451444712 -6.46096556871853e-08 -0.07769233005463107 -0.683 0.6665175125842118 0.6665179371859158 -4.8131548455176976e-08 -0.07769835103442584 -0.6831 0.666528801764072 0.6665292262039233 -3.165418631313928e-08 -0.07770437059303303 -0.6832 0.666540088254747 0.6665405121990938 -1.518094850782442e-08 -0.07771038873067804 -0.6833 0.6665513720567382 0.6665517951720612 1.2847868029880471e-09 -0.07771640544758628 -0.6834000000000001 0.6665626531705129 0.6665630751234939 1.7739643235273328e-08 -0.0777224207439832 -0.6835 0.6665739315965042 0.6665743520540942 3.4180246881107545e-08 -0.07772843462009424 -0.6836 0.6665852073351112 0.666585625964598 5.060322699063091e-08 -0.07773444707614485 -0.6837000000000001 0.6665964803866987 0.6665968968557765 6.700521667721282e-08 -0.0777404581123606 -0.6838000000000001 0.6666077507515973 0.666608164728434 8.338285360440234e-08 -0.07774646772896704 -0.6839000000000001 0.6666190184301037 0.6666194295834093 9.973278065206204e-08 -0.07775247592618968 -0.684 0.6666302834224808 0.6666306914215744 1.160516466432171e-07 -0.07775848270425408 -0.6841 0.6666415457289568 0.6666419502438364 1.323361070205975e-07 -0.07776448806338594 -0.6842 0.6666528053497273 0.6666532060511354 1.4858282450583293e-07 -0.07777049200381088 -0.6843 0.6666640622849527 0.666664458844445 1.647884698176283e-07 -0.07777649452575447 -0.6844000000000001 0.6666753165347605 0.666675708624773 1.8094972233789752e-07 -0.07778249562944245 -0.6845 0.6666865680992446 0.6666869553931604 1.970632707987141e-07 -0.07778849531510054 -0.6846 0.6666978169784651 0.666698199150682 2.1312581396232266e-07 -0.07779449358295443 -0.6847000000000001 0.6667090631724489 0.6667094398984457 2.2913406130115055e-07 -0.0778004904332299 -0.6848000000000001 0.6667203066811898 0.6667206776375925 2.4508473366047223e-07 -0.07780648586615269 -0.6849000000000001 0.6667315475046477 0.6667319123692969 2.60974563931482e-07 -0.07781247988194867 -0.685 0.6667427856427502 0.6667431440947661 2.7680029773824444e-07 -0.07781847248084363 -0.6851 0.6667540210953917 0.6667543728152402 2.925586940830116e-07 -0.07782446366306342 -0.6852 0.6667652538624339 0.6667655985319922 3.082465260401124e-07 -0.07783045342883393 -0.6853 0.6667764839437055 0.6667768212463273 3.238605814359641e-07 -0.07783644177838102 -0.6854000000000001 0.666787711339003 0.6667880409595836 3.393976633903062e-07 -0.07784242871193064 -0.6855 0.666798936048091 0.666799257673131 3.5485459113498985e-07 -0.07784841422970873 -0.6856 0.6668101580707014 0.6668104713883716 3.7022820053439487e-07 -0.07785439833194124 -0.6857000000000001 0.6668213774065342 0.6668216821067399 3.855153448278914e-07 -0.07786038101885423 -0.6858000000000001 0.6668325940552575 0.6668328898297016 4.0071289520576814e-07 -0.07786636229067367 -0.6859000000000001 0.6668438080165082 0.6668440945587538 4.1581774151699946e-07 -0.07787234214762556 -0.686 0.6668550192898913 0.6668552962954257 4.30826792824357e-07 -0.07787832058993603 -0.6861 0.6668662278749812 0.6668664950412773 4.457369781052378e-07 -0.07788429761783118 -0.6862 0.6668774337713206 0.666877690797899 4.6054524689698173e-07 -0.07789027323153706 -0.6863 0.6668886369784217 0.6668888835669131 4.7524856980341035e-07 -0.07789624743127989 -0.6864000000000001 0.6668998374957659 0.6669000733499713 4.898439393136167e-07 -0.07790222021728574 -0.6865 0.6669110353228046 0.6669112601487561 5.043283701905432e-07 -0.07790819158978082 -0.6866 0.666922230458959 0.6669224439649801 5.186989003036491e-07 -0.07791416154899135 -0.6867000000000001 0.6669334229036202 0.6669336248003859 5.329525910174882e-07 -0.07792013009514358 -0.6868000000000001 0.6669446126561495 0.6669448026567454 5.470865280660098e-07 -0.07792609722846369 -0.6869000000000001 0.6669557997158793 0.6669559775358599 5.610978218439922e-07 -0.07793206294917801 -0.687 0.6669669840821124 0.6669671494395598 5.749836081980764e-07 -0.07793802725751287 -0.6871 0.666978165754123 0.6669783183697043 5.887410489680001e-07 -0.07794399015369452 -0.6872 0.6669893447311566 0.6669894843281814 6.023673325555867e-07 -0.07794995163794932 -0.6873 0.6670005210124302 0.6670006473169068 6.158596745492462e-07 -0.07795591171050366 -0.6874000000000001 0.667011694597133 0.6670118073378252 6.292153182235749e-07 -0.07796187037158397 -0.6875 0.6670228654844264 0.667022964392908 6.424315351222232e-07 -0.07796782762141663 -0.6876 0.6670340336734435 0.6670341184841547 6.555056257379066e-07 -0.07797378346022807 -0.6877000000000001 0.6670451991632914 0.6670452696135917 6.684349197899619e-07 -0.07797973788824475 -0.6878000000000001 0.6670563619530496 0.6670564177832723 6.812167770570143e-07 -0.07798569090569317 -0.6879000000000001 0.6670675220417708 0.6670675629952763 6.938485877933109e-07 -0.07799164251279977 -0.688 0.667078679428482 0.6670787052517095 7.063277732838324e-07 -0.07799759270979119 -0.6881 0.6670898341121841 0.6670898445547043 7.186517862606268e-07 -0.07800354149689391 -0.6882 0.667100986091852 0.6671009809064178 7.308181117215984e-07 -0.07800948887433448 -0.6883 0.6671121353664355 0.667112114309033 7.428242670554086e-07 -0.07801543484233958 -0.6884000000000001 0.6671232819348598 0.6671232447647577 7.546678028880205e-07 -0.07802137940113581 -0.6885 0.6671344257960249 0.6671343722758236 7.663463034573992e-07 -0.07802732255094974 -0.6886 0.6671455669488067 0.6671454968444879 7.778573868494343e-07 -0.0780332642920081 -0.6887000000000001 0.6671567053920573 0.6671566184730305 7.891987060804073e-07 -0.07803920462453762 -0.6888000000000001 0.6671678411246047 0.6671677371637557 8.003679489720916e-07 -0.07804514354876488 -0.6889000000000001 0.667178974145254 0.6671788529189902 8.113628391093197e-07 -0.0780510810649167 -0.689 0.6671901044527877 0.6671899657410845 8.221811358261055e-07 -0.07805701717321985 -0.6891 0.6672012320459655 0.6672010756324105 8.328206351215783e-07 -0.0780629518739011 -0.6892 0.6672123569235249 0.667212182595363 8.432791697710051e-07 -0.07806888516718723 -0.6893 0.6672234790841816 0.6672232866323577 8.535546101029468e-07 -0.07807481705330505 -0.6894000000000001 0.6672345985266301 0.6672343877458324 8.6364486398538e-07 -0.0780807475324814 -0.6895 0.6672457152495441 0.6672454859382457 8.735478776444872e-07 -0.07808667660494323 -0.6896 0.6672568292515759 0.6672565812120761 8.832616360254786e-07 -0.0780926042709173 -0.6897000000000001 0.6672679405313586 0.6672676735698229 8.927841629868816e-07 -0.07809853053063065 -0.6898000000000001 0.6672790490875047 0.6672787630140051 9.021135219944298e-07 -0.07810445538431013 -0.6899000000000001 0.6672901549186077 0.6672898495471604 9.112478162320858e-07 -0.07811037883218269 -0.69 0.667301258023242 0.6673009331718462 9.201851892126633e-07 -0.07811630087447538 -0.6901 0.6673123583999636 0.6673120138906383 9.289238250276277e-07 -0.07812222151141512 -0.6902 0.66732345604731 0.6673230917061306 9.374619488466962e-07 -0.07812814074322905 -0.6903 0.6673345509638009 0.667334166620934 9.457978271953937e-07 -0.07813405857014408 -0.6904000000000001 0.667345643147939 0.6673452386376777 9.539297682326087e-07 -0.07813997499238734 -0.6905 0.6673567325982099 0.6673563077590069 9.61856122194682e-07 -0.07814589001018589 -0.6906 0.6673678193130828 0.6673673739875838 9.695752817839853e-07 -0.07815180362376689 -0.6907000000000001 0.6673789032910104 0.6673784373260867 9.770856824464769e-07 -0.07815771583335743 -0.6908000000000001 0.6673899845304305 0.6673894977772086 9.843858026215013e-07 -0.07816362663918464 -0.6909000000000001 0.6674010630297652 0.6674005553436584 9.914741641303682e-07 -0.07816953604147574 -0.691 0.6674121387874223 0.6674116100281596 9.983493324816628e-07 -0.07817544404045794 -0.6911 0.6674232118017949 0.6674226618334496 1.0050099170932913e-06 -0.07818135063635841 -0.6912 0.6674342820712624 0.6674337107622799 1.0114545715700363e-06 -0.07818725582940445 -0.6913 0.6674453495941907 0.6674447568174147 1.0176819941754012e-06 -0.0781931596198232 -0.6914000000000001 0.667456414368933 0.6674558000016322 1.023690927887122e-06 -0.07819906200784212 -0.6915 0.6674674763938299 0.6674668403177221 1.0294801607579895e-06 -0.0782049629936884 -0.6916 0.6674785356672097 0.6674778777684864 1.0350485260268716e-06 -0.07821086257758937 -0.6917000000000001 0.6674895921873893 0.6674889123567385 1.0403949025905579e-06 -0.07821676075977238 -0.6918000000000001 0.6675006459526751 0.6674999440853027 1.04551821500376e-06 -0.07822265754046484 -0.6919000000000001 0.6675116969613617 0.6675109729570143 1.050417433784423e-06 -0.07822855291989406 -0.692 0.6675227452117345 0.6675219989747184 1.0550915756635248e-06 -0.07823444689828751 -0.6921 0.6675337907020689 0.6675330221412699 1.059539703862633e-06 -0.07824033947587265 -0.6922 0.6675448334306308 0.6675440424595325 1.0637609280939042e-06 -0.07824623065287688 -0.6923 0.6675558733956776 0.6675550599323791 1.0677544046155951e-06 -0.07825212042952763 -0.6924000000000001 0.6675669105954583 0.6675660745626903 1.0715193369814635e-06 -0.07825800880605248 -0.6925 0.6675779450282145 0.6675770863533551 1.075054975707701e-06 -0.07826389578267894 -0.6926 0.6675889766921799 0.6675880953072693 1.0783606183284444e-06 -0.0782697813596345 -0.6927000000000001 0.6676000055855817 0.6675991014273355 1.081435610089665e-06 -0.07827566553714678 -0.6928000000000001 0.6676110317066406 0.6676101047164624 1.0842793434218123e-06 -0.07828154831544332 -0.6929000000000001 0.6676220550535712 0.6676211051775649 1.0868912588002377e-06 -0.07828742969475168 -0.693 0.6676330756245835 0.6676321028135633 1.08927084407906e-06 -0.07829330967529957 -0.6931 0.6676440934178818 0.6676430976273824 1.0914176350740323e-06 -0.07829918825731458 -0.6932 0.6676551084316658 0.6676540896219516 1.0933312157290764e-06 -0.07830506544102436 -0.6933 0.6676661206641321 0.6676650788002041 1.0950112177554594e-06 -0.07831094122665666 -0.6934000000000001 0.6676771301134734 0.6676760651650764 1.0964573212146611e-06 -0.07831681561443912 -0.6935 0.6676881367778795 0.667687048719508 1.0976692541853073e-06 -0.07832268860459955 -0.6936 0.6676991406555375 0.6676980294664405 1.0986467929019472e-06 -0.07832856019736556 -0.6937000000000001 0.667710141744633 0.6677090074088181 1.0993897621158766e-06 -0.07833443039296505 -0.6938000000000001 0.6677211400433491 0.6677199825495855 1.0998980346232923e-06 -0.07834029919162566 -0.6939000000000001 0.6677321355498693 0.6677309548916894 1.1001715316538707e-06 -0.07834616659357535 -0.694 0.6677431282623756 0.6677419244380763 1.1002102228707678e-06 -0.07835203259904185 -0.6941 0.6677541181790503 0.6677528911916926 1.100014126148574e-06 -0.07835789720825304 -0.6942 0.6677651052980762 0.6677638551554843 1.0995833077120931e-06 -0.0783637604214368 -0.6943 0.6677760896176368 0.6677748163323967 1.0989178821085854e-06 -0.078369622238821 -0.6944000000000001 0.6677870711359173 0.6677857747253728 1.0980180123465466e-06 -0.0783754826606336 -0.6945 0.6677980498511047 0.6677967303373544 1.0968839093683513e-06 -0.07838134168710244 -0.6946 0.6678090257613886 0.6678076831712804 1.0955158326331205e-06 -0.0783871993184555 -0.6947000000000001 0.6678199988649614 0.6678186332300868 1.0939140896171207e-06 -0.0783930555549208 -0.6948000000000001 0.6678309691600188 0.6678295805167062 1.0920790359802979e-06 -0.0783989103967263 -0.6949000000000001 0.6678419366447608 0.6678405250340669 1.090011075260966e-06 -0.07840476384409999 -0.695 0.667852901317391 0.6678514667850932 1.0877106590423402e-06 -0.07841061589726989 -0.6951 0.6678638631761185 0.6678624057727044 1.085178286702737e-06 -0.07841646655646406 -0.6952 0.6678748222191577 0.6678733419998142 1.0824145052490408e-06 -0.07842231582191062 -0.6953 0.667885778444729 0.6678842754693304 1.0794199095942592e-06 -0.07842816369383765 -0.6954000000000001 0.6678967318510581 0.6678952061841547 1.0761951418913895e-06 -0.0784340101724732 -0.6955 0.6679076824363789 0.6679061341471815 1.0727408916999526e-06 -0.07843985525804548 -0.6956 0.6679186301989317 0.667917059361298 1.0690578958749697e-06 -0.0784456989507826 -0.6957000000000001 0.6679295751369649 0.6679279818293837 1.0651469382616519e-06 -0.0784515412509127 -0.6958000000000001 0.6679405172487347 0.6679389015543102 1.061008849667644e-06 -0.07845738215866406 -0.6959000000000001 0.6679514565325064 0.6679498185389392 1.0566445074189357e-06 -0.07846322167426477 -0.696 0.6679623929865546 0.6679607327861239 1.0520548357206838e-06 -0.07846905979794311 -0.6961 0.667973326609163 0.6679716442987079 1.0472408047967896e-06 -0.07847489652992734 -0.6962 0.667984257398626 0.6679825530795244 1.0422034312507211e-06 -0.07848073187044571 -0.6963 0.6679951853532484 0.6679934591313963 1.0369437774826462e-06 -0.0784865658197266 -0.6964000000000001 0.6680061104713457 0.6680043624571346 1.0314629517449436e-06 -0.07849239837799821 -0.6965 0.6680170327512454 0.6680152630595388 1.025762107559336e-06 -0.07849822954548885 -0.6966 0.6680279521912869 0.6680261609413976 1.019842443883423e-06 -0.07850405932242699 -0.6967000000000001 0.668038868789822 0.6680370561054856 1.013705204527815e-06 -0.07850988770904092 -0.6968000000000001 0.6680497825452149 0.6680479485545654 1.007351678156132e-06 -0.07851571470555901 -0.6969000000000001 0.6680606934558437 0.6680588382913857 1.0007831978131598e-06 -0.0785215403122097 -0.697 0.6680716015201004 0.668069725318682 9.94001140758316e-07 -0.07852736452922138 -0.6971 0.6680825067363907 0.6680806096391747 9.8700692821585e-07 -0.07853318735682255 -0.6972 0.6680934091031352 0.6680914912555695 9.79802024986265e-07 -0.07853900879524156 -0.6973 0.66810430861877 0.668102370170558 9.72387939085495e-07 -0.07854482884470702 -0.6974000000000001 0.6681152052817463 0.6681132463868147 9.647662216061281e-07 -0.07855064750544734 -0.6975 0.6681260990905313 0.6681241199069989 9.569384663010716e-07 -0.07855646477769111 -0.6976 0.6681369900436092 0.6681349907337532 9.489063092504857e-07 -0.07856228066166682 -0.6977000000000001 0.6681478781394801 0.6681458588697031 9.40671428500961e-07 -0.07856809515760303 -0.6978000000000001 0.6681587633766621 0.6681567243174575 9.322355438434737e-07 -0.07857390826572835 -0.6979000000000001 0.6681696457536911 0.6681675870796066 9.236004163137856e-07 -0.07857971998627138 -0.698 0.6681805252691204 0.6681784471587224 9.147678478316212e-07 -0.07858553031946065 -0.6981 0.6681914019215227 0.6681893045573594 9.057396809786233e-07 -0.07859133926552496 -0.6982 0.6682022757094888 0.6682001592780518 8.965177983877304e-07 -0.0785971468246928 -0.6983 0.6682131466316292 0.6682110113233151 8.871041225488874e-07 -0.07860295299719289 -0.6984000000000001 0.6682240146865744 0.6682218606956447 8.775006153927123e-07 -0.07860875778325395 -0.6985 0.6682348798729749 0.6682327073975162 8.677092776521178e-07 -0.07861456118310468 -0.6986 0.6682457421895016 0.6682435514313843 8.577321488068002e-07 -0.07862036319697385 -0.6987000000000001 0.6682566016348463 0.6682543927996825 8.475713063615942e-07 -0.07862616382509013 -0.6988000000000001 0.6682674582077224 0.668265231504823 8.372288655966731e-07 -0.0786319630676823 -0.6989000000000001 0.6682783119068645 0.6682760675491963 8.267069790401926e-07 -0.07863776092497918 -0.699 0.6682891627310297 0.6682869009351711 8.160078361074685e-07 -0.07864355739720953 -0.6991 0.6683000106789975 0.6682977316650931 8.051336625319871e-07 -0.07864935248460221 -0.6992 0.66831085574957 0.6683085597412852 7.94086719949072e-07 -0.07865514618738602 -0.6993 0.6683216979415729 0.6683193851660474 7.828693054517943e-07 -0.07866093850578987 -0.6994000000000001 0.6683325372538549 0.6683302079416558 7.714837511330064e-07 -0.0786667294400426 -0.6995 0.6683433736852887 0.6683410280703628 7.599324235441074e-07 -0.07867251899037314 -0.6996 0.6683542072347715 0.6683518455543958 7.482177232093212e-07 -0.07867830715701037 -0.6997000000000001 0.6683650379012249 0.6683626603959585 7.363420842371182e-07 -0.07868409394018323 -0.6998000000000001 0.6683758656835951 0.668373472597229 7.243079736402036e-07 -0.07868987934012066 -0.6999000000000001 0.6683866905808539 0.6683842821603605 7.121178909885728e-07 -0.07869566335705161 -0.7 0.6683975125919986 0.6683950890874798 6.997743677711332e-07 -0.07870144599120507 -0.7001000000000001 0.6684083317160527 0.6684058933806889 6.872799669793705e-07 -0.0787072272428101 -0.7002 0.6684191479520654 0.6684166950420627 6.746372824689706e-07 -0.07871300711209568 -0.7003 0.6684299612991126 0.6684274940736498 6.618489384740966e-07 -0.07871878559929087 -0.7004000000000001 0.6684407717562968 0.6684382904774716 6.489175890106447e-07 -0.07872456270462472 -0.7005 0.6684515793227481 0.6684490842555227 6.358459175154207e-07 -0.07873033842832627 -0.7006 0.6684623839976237 0.66845987540977 6.226366360412294e-07 -0.07873611277062469 -0.7007000000000001 0.6684731857801085 0.6684706639421527 6.092924848682957e-07 -0.07874188573174902 -0.7008000000000001 0.6684839846694154 0.6684814498545821 5.958162318658866e-07 -0.07874765731192844 -0.7009000000000001 0.6684947806647857 0.6684922331489407 5.822106719094444e-07 -0.07875342751139208 -0.701 0.668505573765489 0.6685030138270829 5.68478626380986e-07 -0.07875919633036908 -0.7011000000000001 0.668516363970824 0.6685137918908337 5.546229424752136e-07 -0.07876496376908868 -0.7012 0.668527151280118 0.6685245673419895 5.406464926860366e-07 -0.07877072982778001 -0.7013 0.6685379356927282 0.6685353401823173 5.265521741681933e-07 -0.07877649450667236 -0.7014000000000001 0.6685487172080407 0.6685461104135538 5.123429081960174e-07 -0.07878225780599492 -0.7015 0.6685594958254721 0.6685568780374068 4.98021639538937e-07 -0.07878801972597699 -0.7016 0.6685702715444684 0.668567643055553 4.83591335753708e-07 -0.07879378026684779 -0.7017 0.6685810443645063 0.6685784054696395 4.6905498678195823e-07 -0.07879953942883663 -0.7018000000000001 0.6685918142850928 0.6685891652812828 4.5441560406200843e-07 -0.07880529721217285 -0.7019000000000001 0.6686025813057654 0.668599922492068 4.3967622014029484e-07 -0.07881105361708574 -0.702 0.6686133454260932 0.6686106771035497 4.2483988794972394e-07 -0.07881680864380461 -0.7021000000000001 0.6686241066456754 0.6686214291172513 4.0990968017129426e-07 -0.07882256229255885 -0.7022 0.6686348649641434 0.6686321785346648 3.9488868858184034e-07 -0.07882831456357786 -0.7023 0.6686456203811597 0.6686429253572508 3.797800234642268e-07 -0.07883406545709104 -0.7024000000000001 0.6686563728964184 0.6686536695864375 3.6458681291345885e-07 -0.07883981497332776 -0.7025 0.6686671225096459 0.6686644112236217 3.49312202274632e-07 -0.07884556311251746 -0.7026 0.6686778692206 0.668675150270168 3.3395935338659255e-07 -0.0788513098748896 -0.7027 0.6686886130290712 0.6686858867274085 3.185314439921316e-07 -0.0788570552606736 -0.7028000000000001 0.6686993539348823 0.6686966205966433 3.0303166709266804e-07 -0.07886279927009898 -0.7029000000000001 0.6687100919378884 0.6687073518791398 2.874632302057867e-07 -0.07886854190339526 -0.703 0.6687208270379773 0.6687180805761322 2.7182935481012693e-07 -0.07887428316079192 -0.7031000000000001 0.6687315592350696 0.6687288066888227 2.561332755959822e-07 -0.07888002304251851 -0.7032 0.668742288529119 0.6687395302183795 2.4037823980610495e-07 -0.07888576154880456 -0.7033 0.668753014920112 0.6687502511659384 2.2456750665283964e-07 -0.07889149867987966 -0.7034000000000001 0.6687637384080682 0.6687609695326019 2.087043465340277e-07 -0.07889723443597332 -0.7035 0.6687744589930408 0.6687716853194385 1.9279204040156817e-07 -0.07890296881731522 -0.7036 0.668785176675116 0.6687823985274843 1.7683387907446724e-07 -0.07890870182413491 -0.7037 0.6687958914544139 0.6687931091577413 1.608331625796433e-07 -0.0789144334566621 -0.7038000000000001 0.6688066033310879 0.6688038172111773 1.4479319945456814e-07 -0.07892016371512639 -0.7039000000000001 0.6688173123053248 0.6688145226887272 1.2871730603256082e-07 -0.07892589259975741 -0.704 0.6688280183773457 0.6688252255912923 1.1260880583910393e-07 -0.07893162011078492 -0.7041000000000001 0.6688387215474048 0.6688359259197392 9.647102882509584e-08 -0.07893734624843857 -0.7042 0.6688494218157908 0.6688466236749011 8.030731072500297e-08 -0.0789430710129481 -0.7043 0.6688601191828258 0.668857318857577 6.412099234215374e-08 -0.07894879440454323 -0.7044000000000001 0.6688708136488662 0.6688680114685323 4.791541884444084e-08 -0.0789545164234537 -0.7045 0.668881505214302 0.6688787015084976 3.169393912941243e-08 -0.0789602370699093 -0.7046 0.6688921938795576 0.66888938897817 1.5459905080075775e-08 -0.07896595634413976 -0.7047 0.6689028796450913 0.6689000738782124 -7.833291116449148e-10 -0.07897167424637494 -0.7048000000000001 0.6689135625113953 0.6689107562092534 -1.7032407632726343e-08 -0.07897739077684464 -0.7049000000000001 0.6689242424789963 0.6689214359718875 -3.328397374683864e-08 -0.07898310593577867 -0.705 0.6689349195484549 0.668932113166675 -4.9534670490728426e-08 -0.07898881972340692 -0.7051000000000001 0.6689455937203653 0.6689427877941422 -6.578114136344612e-08 -0.07899453213995919 -0.7052 0.6689562649953565 0.6689534598547808 -8.202003102131955e-08 -0.07900024318566541 -0.7053 0.6689669333740911 0.668964129349049 -9.824798597509593e-08 -0.07900595286075544 -0.7054000000000001 0.6689775988572658 0.6689747962773704 -1.1446165527548291e-07 -0.07901166116545921 -0.7055 0.6689882614456116 0.6689854606401351 -1.3065769121495263e-07 -0.07901736810000669 -0.7056 0.668998921139893 0.6689961224376981 -1.4683275001599327e-07 -0.07902307366462771 -0.7057 0.6690095779409088 0.6690067816703815 -1.629834925145901e-07 -0.07902877785955235 -0.7058000000000001 0.6690202318494916 0.669017438338473 -1.7910658485845166e-07 -0.07903448068501054 -0.7059000000000001 0.6690308828665075 0.6690280924422265 -1.9519869920783806e-07 -0.07904018214123226 -0.706 0.6690415309928568 0.6690387439818617 -2.1125651437567394e-07 -0.07904588222844755 -0.7061000000000001 0.669052176229473 0.6690493929575648 -2.2727671658562265e-07 -0.07905158094688637 -0.7062 0.6690628185773239 0.6690600393694885 -2.432560000792394e-07 -0.07905727829677883 -0.7063 0.6690734580374098 0.669070683217752 -2.591910678931275e-07 -0.07906297427835492 -0.7064000000000001 0.6690840946107656 0.6690813245024404 -2.750786324279275e-07 -0.07906866889184479 -0.7065 0.6690947282984586 0.6690919632236061 -2.9091541618730954e-07 -0.07907436213747851 -0.7066 0.6691053591015899 0.6691025993812676 -3.0669815254125155e-07 -0.07908005401548615 -0.7067 0.6691159870212929 0.6691132329754108 -3.2242358618400635e-07 -0.07908574452609786 -0.7068000000000001 0.6691266120587349 0.6691238640059878 -3.380884740500356e-07 -0.07909143366954373 -0.7069000000000001 0.6691372342151156 0.6691344924729187 -3.5368958574422127e-07 -0.07909712144605395 -0.707 0.6691478534916673 0.6691451183760899 -3.692237044577995e-07 -0.07910280785585865 -0.7071000000000001 0.6691584698896551 0.6691557417153561 -3.8468762744020557e-07 -0.07910849289918803 -0.7072 0.6691690834103764 0.6691663624905383 -4.000781667484743e-07 -0.07911417657627229 -0.7073 0.6691796940551612 0.6691769807014263 -4.1539214988561834e-07 -0.07911985888734163 -0.7074000000000001 0.6691903018253711 0.6691875963477771 -4.306264204737009e-07 -0.07912553983262631 -0.7075 0.6692009067223997 0.669198209429316 -4.4577783883670286e-07 -0.07913121941235653 -0.7076 0.669211508747673 0.6692088199457358 -4.608432827707398e-07 -0.07913689762676256 -0.7077 0.6692221079026479 0.6692194278966985 -4.758196480506016e-07 -0.0791425744760747 -0.7078000000000001 0.669232704188813 0.6692300332818342 -4.907038491791527e-07 -0.07914824996052323 -0.7079000000000001 0.669243297607688 0.6692406361007417 -5.054928200187714e-07 -0.07915392408033846 -0.708 0.6692538881608235 0.6692512363529883 -5.201835143464617e-07 -0.07915959683575065 -0.7081000000000001 0.6692644758498016 0.6692618340381116 -5.347729064714146e-07 -0.07916526822699023 -0.7082 0.6692750606762338 0.6692724291556171 -5.492579920191032e-07 -0.07917093825428746 -0.7083 0.6692856426417629 0.669283021704981 -5.636357884031273e-07 -0.07917660691787276 -0.7084000000000001 0.6692962217480616 0.6692936116856485 -5.779033355052254e-07 -0.07918227421797651 -0.7085 0.6693067979968321 0.6693041990970352 -5.920576962303858e-07 -0.07918794015482905 -0.7086 0.6693173713898071 0.6693147839385272 -6.060959571313473e-07 -0.07919360472866083 -0.7087 0.6693279419287481 0.6693253662094805 -6.200152291163663e-07 -0.0791992679397023 -0.7088000000000001 0.6693385096154458 0.6693359459092223 -6.338126479071837e-07 -0.07920492978818391 -0.7089000000000001 0.6693490744517199 0.6693465230370504 -6.4748537463577e-07 -0.07921059027433602 -0.709 0.6693596364394189 0.669357097592234 -6.610305966631147e-07 -0.07921624939838913 -0.7091000000000001 0.6693701955804195 0.6693676695740144 -6.744455277041261e-07 -0.07922190716057381 -0.7092 0.6693807518766268 0.6693782389816036 -6.877274088268326e-07 -0.07922756356112047 -0.7093 0.6693913053299734 0.6693888058141868 -7.008735088409601e-07 -0.07923321860025964 -0.7094000000000001 0.6694018559424195 0.6693993700709211 -7.138811248946775e-07 -0.07923887227822188 -0.7095 0.6694124037159528 0.6694099317509359 -7.267475830435854e-07 -0.0792445245952377 -0.7096 0.6694229486525877 0.6694204908533342 -7.394702387086838e-07 -0.07925017555153771 -0.7097 0.6694334907543652 0.6694310473771917 -7.520464773841384e-07 -0.07925582514735241 -0.7098000000000001 0.6694440300233528 0.669441601321558 -7.64473715067493e-07 -0.07926147338291238 -0.7099000000000001 0.6694545664616445 0.6694521526854569 -7.767493987315133e-07 -0.07926712025844834 -0.71 0.6694651000713592 0.6694627014678856 -7.88871007087466e-07 -0.07927276577419082 -0.7101000000000001 0.6694756308546412 0.6694732476678164 -8.008360506822632e-07 -0.07927840993037043 -0.7102 0.6694861588136609 0.6694837912841962 -8.126420730086847e-07 -0.07928405272721788 -0.7103 0.6694966839506118 0.6694943323159475 -8.242866505331348e-07 -0.07928969416496369 -0.7104000000000001 0.6695072062677134 0.6695048707619677 -8.357673933895304e-07 -0.07929533424383871 -0.7105 0.6695177257672085 0.6695154066211306 -8.470819456291023e-07 -0.07930097296407355 -0.7106 0.6695282424513633 0.6695259398922863 -8.58227986233473e-07 -0.07930661032589892 -0.7107 0.6695387563224677 0.6695364705742609 -8.692032290730234e-07 -0.07931224632954552 -0.7108000000000001 0.6695492673828347 0.669546998665858 -8.800054236562938e-07 -0.07931788097524409 -0.7109000000000001 0.6695597756347995 0.6695575241658579 -8.906323553242723e-07 -0.07932351426322534 -0.711 0.66957028108072 0.6695680470730193 -9.010818461246961e-07 -0.07932914619372007 -0.7111000000000001 0.6695807837229757 0.6695785673860786 -9.113517548259287e-07 -0.07933477676695908 -0.7112 0.6695912835639677 0.6695890851037508 -9.214399777357496e-07 -0.07934040598317313 -0.7113 0.6696017806061179 0.6695996002247293 -9.313444488678879e-07 -0.07934603384259299 -0.7114000000000001 0.6696122748518694 0.6696101127476868 -9.410631404693781e-07 -0.07935166034544949 -0.7115 0.6696227663036849 0.669620622671276 -9.505940634924048e-07 -0.07935728549197345 -0.7116 0.6696332549640482 0.6696311299941294 -9.599352678579809e-07 -0.07936290928239575 -0.7117 0.6696437408354616 0.6696416347148597 -9.690848429555476e-07 -0.07936853171694724 -0.7118000000000001 0.6696542239204468 0.6696521368320607 -9.78040918031553e-07 -0.07937415279585874 -0.7119000000000001 0.6696647042215443 0.669662636344307 -9.868016626057852e-07 -0.07937977251936121 -0.712 0.6696751817413127 0.6696731332501551 -9.95365286637906e-07 -0.07938539088768545 -0.7121000000000001 0.669685656482329 0.6696836275481435 -1.0037300413046069e-06 -0.07939100790106246 -0.7122 0.6696961284471874 0.6696941192367927 -1.0118942189440983e-06 -0.07939662355972311 -0.7123 0.6697065976384987 0.6697046083146072 -1.019856153777754e-06 -0.07940223786389838 -0.7124000000000001 0.669717064058891 0.6697150947800736 -1.0276142217713335e-06 -0.0794078508138192 -0.7125 0.6697275277110081 0.6697255786316629 -1.0351668414676496e-06 -0.07941346240971653 -0.7126 0.66973798859751 0.6697360598678298 -1.0425124739310565e-06 -0.07941907265182135 -0.7127 0.6697484467210717 0.669746538487014 -1.0496496234135844e-06 -0.0794246815403647 -0.7128000000000001 0.6697589020843832 0.6697570144876399 -1.0565768374382056e-06 -0.07943028907557752 -0.7129000000000001 0.6697693546901489 0.6697674878681178 -1.0632927071041465e-06 -0.07943589525769086 -0.713 0.669779804541087 0.6697779586268435 -1.069795867336687e-06 -0.07944150008693576 -0.7131000000000001 0.6697902516399296 0.6697884267621995 -1.0760849973312503e-06 -0.07944710356354327 -0.7132000000000001 0.6698006959894218 0.669798892272555 -1.0821588207476918e-06 -0.07945270568774446 -0.7133 0.669811137592321 0.6698093551562662 -1.0880161059323434e-06 -0.07945830645977035 -0.7134000000000001 0.6698215764513976 0.6698198154116772 -1.0936556661400587e-06 -0.07946390587985208 -0.7135 0.6698320125694328 0.6698302730371205 -1.099076359950546e-06 -0.07946950394822068 -0.7136 0.6698424459492194 0.6698407280309171 -1.1042770913516353e-06 -0.07947510066510732 -0.7137 0.669852876593561 0.6698511803913774 -1.1092568097947897e-06 -0.0794806960307431 -0.7138000000000001 0.669863304505272 0.6698616301168007 -1.1140145110555277e-06 -0.07948629004535923 -0.7139000000000001 0.6698737296871755 0.6698720772054769 -1.11854923656729e-06 -0.07949188270918676 -0.714 0.6698841521421055 0.6698825216556863 -1.1228600743096173e-06 -0.0794974740224569 -0.7141000000000001 0.6698945718729039 0.6698929634657005 -1.1269461585583507e-06 -0.07950306398540087 -0.7142000000000001 0.6699049888824212 0.6699034026337816 -1.1308066703297204e-06 -0.0795086525982498 -0.7143 0.669915403173516 0.6699138391581847 -1.1344408374358572e-06 -0.07951423986123489 -0.7144000000000001 0.6699258147490545 0.6699242730371568 -1.1378479347345927e-06 -0.07951982577458744 -0.7145 0.6699362236119096 0.6699347042689383 -1.1410272841017033e-06 -0.0795254103385386 -0.7146 0.6699466297649609 0.669945132851762 -1.143978254680711e-06 -0.0795309935533196 -0.7147 0.669957033211094 0.6699555587838554 -1.146700262993905e-06 -0.07953657541916172 -0.7148000000000001 0.6699674339532007 0.6699659820634404 -1.1491927731921425e-06 -0.07954215593629632 -0.7149000000000001 0.6699778319941765 0.6699764026887333 -1.1514552968605596e-06 -0.0795477351049546 -0.715 0.6699882273369226 0.6699868206579455 -1.1534873933516376e-06 -0.07955331292536778 -0.7151000000000001 0.6699986199843444 0.669997235969285 -1.1552886698684706e-06 -0.07955888939776729 -0.7152000000000001 0.6700090099393501 0.6700076486209552 -1.1568587814092535e-06 -0.0795644645223844 -0.7153 0.6700193972048516 0.6700180586111573 -1.1581974310448384e-06 -0.07957003829945047 -0.7154 0.6700297817837633 0.6700284659380888 -1.1593043696689342e-06 -0.07957561072919679 -0.7155 0.6700401636790017 0.6700388705999456 -1.1601793964144402e-06 -0.07958118181185475 -0.7156 0.6700505428934853 0.6700492725949213 -1.1608223584314015e-06 -0.0795867515476557 -0.7157 0.6700609194301332 0.6700596719212086 -1.1612331509147644e-06 -0.07959231993683101 -0.7158000000000001 0.6700712932918658 0.6700700685769997 -1.1614117173264216e-06 -0.07959788697961213 -0.7159000000000001 0.6700816644816033 0.6700804625604857 -1.161358049284189e-06 -0.07960345267623044 -0.716 0.6700920330022657 0.6700908538698586 -1.1610721863397622e-06 -0.07960901702691733 -0.7161000000000001 0.6701023988567723 0.6701012425033107 -1.1605542163117821e-06 -0.07961458003190425 -0.7162000000000001 0.6701127620480409 0.6701116284590357 -1.1598042751748139e-06 -0.07962014169142262 -0.7163 0.6701231225789879 0.6701220117352291 -1.1588225470315905e-06 -0.07962570200570393 -0.7164 0.6701334804525272 0.6701323923300885 -1.157609263863213e-06 -0.07963126097497965 -0.7165 0.67014383567157 0.6701427702418138 -1.1561647056956836e-06 -0.07963681859948124 -0.7166 0.6701541882390243 0.6701531454686085 -1.1544892005721508e-06 -0.07964237487944022 -0.7167 0.6701645381577943 0.6701635180086796 -1.1525831243863749e-06 -0.07964792981508811 -0.7168000000000001 0.6701748854307801 0.6701738878602376 -1.15044690068844e-06 -0.07965348340665634 -0.7169000000000001 0.6701852300608772 0.6701842550214985 -1.1480810007680198e-06 -0.0796590356543765 -0.717 0.6701955720509756 0.670194619490683 -1.1454859436543785e-06 -0.07966458655848013 -0.7171000000000001 0.67020591140396 0.6702049812660176 -1.1426622956167698e-06 -0.07967013611919878 -0.7172000000000001 0.6702162481227087 0.6702153403457344 -1.1396106703309705e-06 -0.079675684336764 -0.7173 0.6702265822100935 0.6702256967280724 -1.1363317288515251e-06 -0.07968123121140737 -0.7174 0.6702369136689788 0.6702360504112775 -1.132826179250923e-06 -0.07968677674336047 -0.7175 0.6702472425022221 0.6702464013936031 -1.129094776369799e-06 -0.07969232093285494 -0.7176 0.6702575687126723 0.6702567496733106 -1.1251383220389766e-06 -0.07969786378012234 -0.7177 0.6702678923031697 0.6702670952486698 -1.1209576646908914e-06 -0.07970340528539434 -0.7178000000000001 0.670278213276546 0.6702774381179594 -1.1165536989710123e-06 -0.07970894544890252 -0.7179000000000001 0.6702885316356231 0.6702877782794676 -1.1119273659876416e-06 -0.07971448427087854 -0.718 0.670298847383213 0.6702981157314924 -1.1070796527568039e-06 -0.07972002175155413 -0.7181000000000001 0.6703091605221173 0.6703084504723422 -1.1020115923132678e-06 -0.07972555789116086 -0.7182000000000001 0.6703194710551269 0.670318782500336 -1.0967242631276797e-06 -0.07973109268993045 -0.7183 0.670329778985021 0.6703291118138042 -1.091218788967785e-06 -0.0797366261480946 -0.7184 0.6703400843145675 0.6703394384110888 -1.0854963390927175e-06 -0.07974215826588503 -0.7185 0.6703503870465213 0.6703497622905443 -1.0795581273093102e-06 -0.07974768904353342 -0.7186 0.6703606871836254 0.6703600834505375 -1.073405412221895e-06 -0.07975321848127154 -0.7187 0.6703709847286088 0.6703704018894486 -1.067039496954747e-06 -0.07975874657933106 -0.7188000000000001 0.6703812796841874 0.6703807176056709 -1.060461728596973e-06 -0.07976427333794378 -0.7189000000000001 0.6703915720530632 0.6703910305976118 -1.0536734981470008e-06 -0.07976979875734146 -0.719 0.6704018618379233 0.6704013408636937 -1.046676239957467e-06 -0.07977532283775587 -0.7191000000000001 0.6704121490414399 0.6704116484023532 -1.0394714319850173e-06 -0.07978084557941881 -0.7192000000000001 0.6704224336662697 0.6704219532120425 -1.0320605948743733e-06 -0.07978636698256203 -0.7193 0.670432715715054 0.6704322552912292 -1.024445291847309e-06 -0.0797918870474174 -0.7194 0.6704429951904175 0.6704425546383979 -1.0166271284806072e-06 -0.0797974057742167 -0.7195 0.6704532720949679 0.6704528512520488 -1.0086077522897252e-06 -0.07980292316319175 -0.7196 0.6704635464312961 0.6704631451306997 -1.0003888525345062e-06 -0.07980843921457438 -0.7197 0.6704738182019758 0.6704734362728859 -9.919721594697783e-07 -0.07981395392859646 -0.7198000000000001 0.6704840874095624 0.6704837246771604 -9.833594444841331e-07 -0.07981946730548986 -0.7199000000000001 0.6704943540565925 0.6704940103420945 -9.745525192395021e-07 -0.07982497934548641 -0.72 0.6705046181455847 0.6705042932662784 -9.65553235809935e-07 -0.07983049004881805 -0.7201000000000001 0.6705148796790381 0.6705145734483208 -9.56363485932199e-07 -0.07983599941571665 -0.7202000000000001 0.6705251386594322 0.6705248508868507 -9.469852005616897e-07 -0.07984150744641415 -0.7203 0.670535395089226 0.6705351255805164 -9.374203497058975e-07 -0.07984701414114237 -0.7204 0.6705456489708591 0.6705453975279869 -9.276709419803186e-07 -0.07985251950013333 -0.7205 0.6705559003067496 0.6705556667279514 -9.177390239978322e-07 -0.07985802352361893 -0.7206 0.6705661490992945 0.6705659331791207 -9.076266802299227e-07 -0.07986352621183108 -0.7207 0.6705763953508694 0.6705761968802267 -8.973360322711565e-07 -0.0798690275650018 -0.7208000000000001 0.6705866390638282 0.6705864578300238 -8.868692385477495e-07 -0.07987452758336305 -0.7209000000000001 0.6705968802405021 0.6705967160272878 -8.762284939289877e-07 -0.07988002626714685 -0.721 0.6706071188831999 0.6706069714708169 -8.654160292415058e-07 -0.07988552361658513 -0.7211000000000001 0.6706173549942072 0.6706172241594331 -8.544341105753972e-07 -0.07989101963190987 -0.7212000000000001 0.6706275885757862 0.6706274740919813 -8.432850391593139e-07 -0.0798965143133531 -0.7213 0.6706378196301755 0.6706377212673301 -8.319711506526994e-07 -0.07990200766114691 -0.7214 0.6706480481595898 0.670647965684372 -8.204948146461888e-07 -0.0799074996755233 -0.7215 0.6706582741662188 0.6706582073420237 -8.088584343424188e-07 -0.07991299035671424 -0.7216 0.6706684976522277 0.670668446239227 -7.970644458898946e-07 -0.07991847970495188 -0.7217 0.6706787186197571 0.670678682374948 -7.851153179666559e-07 -0.07992396772046823 -0.7218000000000001 0.6706889370709213 0.6706889157481792 -7.73013551266799e-07 -0.07992945440349537 -0.7219000000000001 0.6706991530078095 0.6706991463579377 -7.607616779037318e-07 -0.07993493975426541 -0.722 0.6707093664324844 0.6707093742032674 -7.483622609938401e-07 -0.07994042377301042 -0.7221000000000001 0.6707195773469828 0.6707195992832379 -7.358178938793314e-07 -0.07994590645996252 -0.7222000000000001 0.6707297857533145 0.6707298215969455 -7.231311999617018e-07 -0.07995138781535382 -0.7223 0.6707399916534621 0.6707400411435139 -7.103048319384575e-07 -0.07995686783941647 -0.7224 0.6707501950493814 0.6707502579220935 -6.97341471053714e-07 -0.07996234653238259 -0.7225 0.6707603959430002 0.6707604719318621 -6.842438270426854e-07 -0.07996782389448427 -0.7226 0.6707705943362187 0.6707706831720257 -6.710146370908499e-07 -0.07997329992595376 -0.7227 0.6707807902309088 0.6707808916418182 -6.576566655008831e-07 -0.07997877462702319 -0.7228000000000001 0.6707909836289142 0.6707910973405015 -6.441727030681577e-07 -0.0799842479979247 -0.7229000000000001 0.6708011745320499 0.6708013002673663 -6.30565566428487e-07 -0.0799897200388905 -0.723 0.6708113629421015 0.6708115004217323 -6.168380976556698e-07 -0.07999519075015282 -0.7231000000000001 0.6708215488608259 0.670821697802948 -6.029931634982111e-07 -0.08000066013194378 -0.7232000000000001 0.6708317322899506 0.6708318924103915 -5.890336548797226e-07 -0.08000612818449565 -0.7233 0.6708419132311734 0.6708420842434708 -5.749624862050329e-07 -0.08001159490804072 -0.7234 0.6708520916861617 0.6708522733016229 -5.607825947911982e-07 -0.08001706030281114 -0.7235 0.6708622676565531 0.6708624595843153 -5.464969402013686e-07 -0.08002252436903917 -0.7236 0.670872441143955 0.6708726430910458 -5.321085038839657e-07 -0.08002798710695708 -0.7237 0.6708826121499436 0.6708828238213427 -5.176202881596037e-07 -0.08003344851679711 -0.7238000000000001 0.6708927806760652 0.6708930017747649 -5.030353159435341e-07 -0.08003890859879155 -0.7239000000000001 0.6709029467238343 0.6709031769509022 -4.883566298713449e-07 -0.08004436735317266 -0.724 0.6709131102947348 0.6709133493493757 -4.735872918132378e-07 -0.08004982478017278 -0.7241000000000001 0.6709232713902187 0.6709235189698379 -4.587303821523836e-07 -0.0800552808800242 -0.7242000000000001 0.6709334300117068 0.6709336858119722 -4.437889992298105e-07 -0.08006073565295921 -0.7243 0.670943586160588 0.6709438498754942 -4.2876625856030914e-07 -0.08006618909921015 -0.7244 0.6709537398382192 0.6709540111601511 -4.13665292339771e-07 -0.08007164121900934 -0.7245 0.670963891045925 0.6709641696657223 -3.984892486749714e-07 -0.0800770920125891 -0.7246 0.6709740397849985 0.670974325392019 -3.8324129101457993e-07 -0.08008254148018183 -0.7247 0.6709841860566995 0.6709844783388852 -3.679245974413936e-07 -0.08008798962201985 -0.7248000000000001 0.6709943298622558 0.670994628506197 -3.525423599576305e-07 -0.08009343643833557 -0.7249000000000001 0.6710044712028624 0.6710047758938631 -3.3709778395757395e-07 -0.08009888192936129 -0.725 0.6710146100796818 0.671014920501825 -3.215940874504164e-07 -0.08010432609532951 -0.7251000000000001 0.6710247464938425 0.6710250623300573 -3.0603450044269787e-07 -0.08010976893647254 -0.7252000000000001 0.671034880446441 0.671035201378567 -2.9042226423747763e-07 -0.08011521045302278 -0.7253000000000001 0.6710450119385404 0.671045337647395 -2.7476063076820045e-07 -0.08012065064521272 -0.7254 0.6710551409711702 0.6710554711366143 -2.5905286191868493e-07 -0.08012608951327471 -0.7255 0.6710652675453268 0.6710656018463322 -2.433022288569897e-07 -0.0801315270574412 -0.7256 0.6710753916619729 0.6710757297766887 -2.275120113345852e-07 -0.08013696327794467 -0.7257 0.6710855133220381 0.6710858549278577 -2.116854970306281e-07 -0.08014239817501752 -0.7258000000000001 0.6710956325264179 0.6710959773000463 -1.958259808199081e-07 -0.08014783174889223 -0.7259000000000001 0.6711057492759743 0.6711060968934955 -1.7993676417610294e-07 -0.0801532639998013 -0.726 0.6711158635715354 0.6711162137084796 -1.6402115435298903e-07 -0.08015869492797717 -0.7261 0.671125975413896 0.671126327745307 -1.4808246383279933e-07 -0.08016412453365235 -0.7262000000000001 0.671136084803816 0.6711364390043195 -1.3212400954906722e-07 -0.08016955281705929 -0.7263000000000001 0.6711461917420225 0.6711465474858931 -1.1614911222049273e-07 -0.08017497977843051 -0.7264 0.6711562962292085 0.6711566531904373 -1.0016109567266562e-07 -0.08018040541799859 -0.7265 0.6711663982660321 0.6711667561183956 -8.416328612335933e-08 -0.08018582973599597 -0.7266 0.6711764978531183 0.6711768562702453 -6.815901150772352e-08 -0.08019125273265518 -0.7267 0.6711865949910584 0.6711869536464978 -5.215160077485376e-08 -0.08019667440820884 -0.7268000000000001 0.6711966896804085 0.6711970482476983 -3.614438320702091e-08 -0.08020209476288945 -0.7269000000000001 0.6712067819216914 0.671207140074426 -2.0140687716132394e-08 -0.08020751379692953 -0.727 0.6712168717153961 0.6712172291272933 -4.143842156564825e-09 -0.08021293151056166 -0.7271 0.6712269590619775 0.6712273154069477 1.1842827369809572e-08 -0.08021834790401844 -0.7272000000000001 0.6712370439618559 0.6712373989140699 2.7815997205235532e-08 -0.08022376297753242 -0.7273000000000001 0.6712471264154188 0.6712474796493741 4.377234682356734e-08 -0.08022917673133621 -0.7274 0.6712572064230192 0.6712575576136092 5.970855951852039e-08 -0.08023458916566245 -0.7275 0.6712672839849764 0.6712676328075569 7.56213231097036e-08 -0.0802400002807437 -0.7276 0.6712773591015754 0.6712777052320331 9.15073306261005e-08 -0.08024541007681259 -0.7277 0.6712874317730679 0.6712877748878874 1.0736328097046832e-07 -0.08025081855410172 -0.7278000000000001 0.6712975019996721 0.6712978417760028 1.2318587962883987e-07 -0.08025622571284377 -0.7279000000000001 0.6713075697815718 0.6713079058972958 1.389718393696171e-07 -0.08026163155327135 -0.728 0.6713176351189184 0.6713179672527164 1.5471788089582716e-07 -0.0802670360756171 -0.7281 0.6713276980118291 0.6713280258432477 1.7042073352166454e-07 -0.08027243928011364 -0.7282000000000001 0.6713377584603882 0.6713380816699065 1.8607713590454433e-07 -0.08027784116699371 -0.7283000000000001 0.6713478164646464 0.6713481347337426 2.0168383666613332e-07 -0.08028324173648999 -0.7284 0.6713578720246212 0.6713581850358386 2.172375951001171e-07 -0.0802886409888351 -0.7285 0.6713679251402974 0.67136823257731 2.327351818556811e-07 -0.08029403892426178 -0.7286 0.6713779758116266 0.6713782773593057 2.4817337955507224e-07 -0.08029943554300267 -0.7287 0.671388024038528 0.6713883193830067 2.635489834840188e-07 -0.08030483084529054 -0.7288000000000001 0.6713980698208879 0.6713983586496268 2.788588023619476e-07 -0.08031022483135808 -0.7289000000000001 0.6714081131585599 0.6714083951604122 2.940996588415845e-07 -0.08031561750143801 -0.729 0.6714181540513653 0.6714184289166412 3.0926839027223263e-07 -0.08032100885576303 -0.7291 0.6714281924990936 0.6714284599196241 3.2436184929651724e-07 -0.08032639889456589 -0.7292000000000001 0.6714382285015019 0.6714384881707036 3.3937690457896963e-07 -0.08033178761807934 -0.7293000000000001 0.6714482620583156 0.6714485136712542 3.543104413958331e-07 -0.08033717502653615 -0.7294 0.6714582931692283 0.6714585364226813 3.6915936228731905e-07 -0.08034256112016908 -0.7295 0.6714683218339021 0.6714685564264227 3.839205877514962e-07 -0.0803479458992109 -0.7296 0.6714783480519677 0.6714785736839465 3.985910568410356e-07 -0.08035332936389439 -0.7297 0.6714883718230248 0.6714885881967523 4.1316772776689437e-07 -0.0803587115144523 -0.7298000000000001 0.6714983931466417 0.6714985999663705 4.2764757857138846e-07 -0.08036409235111741 -0.7299000000000001 0.6715084120223567 0.6715086089943626 4.4202760782208195e-07 -0.08036947187412258 -0.73 0.6715184284496769 0.6715186152823197 4.563048351113874e-07 -0.08037485008370057 -0.7301 0.6715284424280796 0.6715286188318637 4.704763017504554e-07 -0.08038022698008424 -0.7302000000000001 0.6715384539570117 0.671538619644646 4.845390713520414e-07 -0.08038560256350635 -0.7303000000000001 0.6715484630358903 0.6715486177223483 4.984902304688843e-07 -0.08039097683419977 -0.7304 0.6715584696641035 0.6715586130666813 5.123268891904509e-07 -0.08039634979239735 -0.7305 0.6715684738410089 0.6715686056793855 5.260461817396811e-07 -0.08040172143833191 -0.7306 0.6715784755659358 0.6715785955622299 5.396452670142216e-07 -0.0804070917722363 -0.7307 0.6715884748381843 0.6715885827170122 5.531213293358261e-07 -0.08041246079434333 -0.7308000000000001 0.671598471657026 0.6715985671455595 5.664715788389341e-07 -0.08041782850488598 -0.7309000000000001 0.6716084660217044 0.6716085488497263 5.796932521506815e-07 -0.08042319490409705 -0.731 0.6716184579314346 0.6716185278313951 5.927836129460129e-07 -0.08042855999220945 -0.7311 0.671628447385404 0.6716285040924765 6.057399525166707e-07 -0.08043392376945602 -0.7312000000000001 0.6716384343827726 0.6716384776349079 6.185595904095731e-07 -0.08043928623606968 -0.7313000000000001 0.671648418922673 0.6716484484606544 6.312398748709036e-07 -0.08044464739228332 -0.7314 0.6716584010042114 0.6716584165717074 6.437781833734668e-07 -0.08045000723832986 -0.7315 0.6716683806264668 0.6716683819700855 6.561719233383334e-07 -0.08045536577444225 -0.7316 0.6716783577884922 0.6716783446578327 6.684185324540293e-07 -0.08046072300085336 -0.7317 0.6716883324893147 0.6716883046370195 6.805154793981805e-07 -0.08046607891779613 -0.7318000000000001 0.6716983047279355 0.6716982619097414 6.924602642122135e-07 -0.08047143352550355 -0.7319000000000001 0.6717082745033307 0.6717082164781196 7.04250418981367e-07 -0.08047678682420852 -0.732 0.6717182418144514 0.6717181683443001 7.158835081538806e-07 -0.08048213881414401 -0.7321 0.6717282066602235 0.6717281175104532 7.273571291377401e-07 -0.08048748949554296 -0.7322000000000001 0.6717381690395494 0.6717380639787739 7.386689129390556e-07 -0.08049283886863837 -0.7323000000000001 0.6717481289513072 0.6717480077514806 7.49816524384106e-07 -0.0804981869336632 -0.7324 0.6717580863943508 0.6717579488308154 7.607976627854729e-07 -0.08050353369085035 -0.7325 0.6717680413675116 0.6717678872190438 7.716100623306188e-07 -0.0805088791404329 -0.7326 0.6717779938695975 0.6717778229184539 7.822514927757762e-07 -0.08051422328264382 -0.7327 0.6717879438993943 0.6717877559313563 7.927197594598256e-07 -0.0805195661177161 -0.7328000000000001 0.6717978914556653 0.6717976862600838 8.03012704192474e-07 -0.08052490764588272 -0.7329000000000001 0.6718078365371521 0.6718076139069911 8.131282055318101e-07 -0.08053024786737673 -0.733 0.671817779142575 0.6718175388744536 8.230641791728832e-07 -0.08053558678243117 -0.7331 0.6718277192706328 0.6718274611648679 8.328185784056696e-07 -0.08054092439127897 -0.7332000000000001 0.6718376569200042 0.6718373807806516 8.423893946979399e-07 -0.08054626069415326 -0.7333000000000001 0.6718475920893473 0.671847297724242 8.517746578062813e-07 -0.08055159569128703 -0.7334 0.6718575247773003 0.6718572119980964 8.6097243651162e-07 -0.08055692938291331 -0.7335 0.6718674549824822 0.6718671236046918 8.699808387579999e-07 -0.08056226176926524 -0.7336 0.6718773827034923 0.6718770325465233 8.787980122493266e-07 -0.0805675928505758 -0.7337 0.6718873079389122 0.6718869388261054 8.874221446297792e-07 -0.08057292262707808 -0.7338000000000001 0.671897230687304 0.6718968424459703 8.958514640389215e-07 -0.08057825109900509 -0.7339000000000001 0.6719071509472132 0.6719067434086681 9.040842393615023e-07 -0.08058357826659 -0.734 0.6719170687171669 0.6719166417167663 9.121187806715447e-07 -0.08058890413006586 -0.7341 0.6719269839956759 0.6719265373728492 9.199534395376574e-07 -0.0805942286896657 -0.7342000000000001 0.671936896781234 0.6719364303795179 9.275866092728347e-07 -0.08059955194562274 -0.7343000000000001 0.671946807072319 0.6719463207393888 9.350167254340569e-07 -0.08060487389816999 -0.7344 0.6719567148673928 0.6719562084550943 9.422422660443353e-07 -0.08061019454754054 -0.7345 0.6719666201649026 0.6719660935292824 9.492617518425117e-07 -0.08061551389396755 -0.7346 0.6719765229632798 0.6719759759646153 9.56073746949393e-07 -0.08062083193768414 -0.7347 0.6719864232609422 0.67198585576377 9.626768586457057e-07 -0.08062614867892344 -0.7348000000000001 0.6719963210562933 0.6719957329294366 9.690697380104751e-07 -0.08063146411791855 -0.7349000000000001 0.6720062163477232 0.6720056074643194 9.752510800042913e-07 -0.08063677825490262 -0.735 0.672016109133609 0.672015479371135 9.812196238578874e-07 -0.08064209109010881 -0.7351 0.6720259994123149 0.6720253486526133 9.869741534052068e-07 -0.08064740262377025 -0.7352000000000001 0.6720358871821934 0.6720352153114951 9.925134971111582e-07 -0.08065271285612013 -0.7353000000000001 0.6720457724415849 0.6720450793505337 9.978365284601942e-07 -0.08065802178739155 -0.7354 0.6720556551888187 0.6720549407724936 1.0029421661506e-06 -0.08066332941781772 -0.7355 0.6720655354222138 0.6720647995801491 1.0078293744275602e-06 -0.08066863574763183 -0.7356 0.6720754131400781 0.6720746557762853 1.012497163027648e-06 -0.080673940777067 -0.7357 0.6720852883407102 0.6720845093636973 1.0169445877339367e-06 -0.08067924450635647 -0.7358000000000001 0.6720951610223994 0.6720943603451888 1.0211707500984435e-06 -0.08068454693573344 -0.7359000000000001 0.6721050311834258 0.6721042087235727 1.0251747982470416e-06 -0.08068984806543107 -0.736 0.6721148988220609 0.6721140545016702 1.0289559265463932e-06 -0.08069514789568258 -0.7361 0.6721247639365688 0.6721238976823098 1.0325133759370164e-06 -0.08070044642672113 -0.7362000000000001 0.672134626525206 0.6721337382683283 1.0358464341830853e-06 -0.08070574365877999 -0.7363000000000001 0.6721444865862216 0.6721435762625686 1.0389544358446745e-06 -0.08071103959209235 -0.7364 0.6721543441178588 0.6721534116678805 1.041836762416537e-06 -0.08071633422689145 -0.7365 0.6721641991183545 0.6721632444871194 1.044492842661171e-06 -0.08072162756341053 -0.7366 0.67217405158594 0.6721730747231461 1.0469221526088202e-06 -0.0807269196018828 -0.7367 0.6721839015188413 0.6721829023788268 1.0491242155852287e-06 -0.08073221034254152 -0.7368000000000001 0.6721937489152807 0.6721927274570316 1.0510986023504199e-06 -0.08073749978561995 -0.7369000000000001 0.6722035937734756 0.6722025499606353 1.0528449312374732e-06 -0.08074278793135134 -0.737 0.6722134360916397 0.6722123698925154 1.054362868235792e-06 -0.08074807477996891 -0.7371 0.672223275867984 0.6722221872555527 1.055652127074369e-06 -0.08075336033170592 -0.7372000000000001 0.6722331131007171 0.6722320020526309 1.0567124689997431e-06 -0.08075864458679566 -0.7373000000000001 0.6722429477880446 0.6722418142866349 1.0575437032200874e-06 -0.08076392754547136 -0.7374 0.6722527799281715 0.6722516239604521 1.0581456867109207e-06 -0.08076920920796636 -0.7375 0.672262609519301 0.6722614310769707 1.0585183243261298e-06 -0.08077448957451393 -0.7376 0.6722724365596353 0.672271235639079 1.0586615687424583e-06 -0.08077976864534729 -0.7377 0.6722822610473778 0.672281037649666 1.05857542062604e-06 -0.08078504642069985 -0.7378000000000001 0.6722920829807304 0.6722908371116197 1.0582599283825989e-06 -0.08079032290080486 -0.7379000000000001 0.6723019023578969 0.6723006340278277 1.0577151883517377e-06 -0.08079559808589558 -0.738 0.6723117191770824 0.6723104284011758 1.0569413444461162e-06 -0.08080087197620534 -0.7381 0.6723215334364934 0.6723202202345484 1.0559385888453399e-06 -0.08080614457196748 -0.7382000000000001 0.6723313451343386 0.6723300095308271 1.0547071611355374e-06 -0.08081141587341531 -0.7383000000000001 0.6723411542688296 0.672339796292891 1.05324734875345e-06 -0.08081668588078211 -0.7384000000000001 0.6723509608381815 0.6723495805236157 1.0515594867643863e-06 -0.08082195459430129 -0.7385 0.6723607648406125 0.6723593622258728 1.049643957529156e-06 -0.0808272220142061 -0.7386 0.6723705662743455 0.6723691414025297 1.0475011912591814e-06 -0.0808324881407299 -0.7387 0.6723803651376083 0.6723789180564492 1.0451316653503628e-06 -0.08083775297410606 -0.7388000000000001 0.6723901614286332 0.6723886921904887 1.0425359046328797e-06 -0.08084301651456788 -0.7389000000000001 0.6723999551456586 0.6723984638074999 1.0397144808438341e-06 -0.08084827876234878 -0.739 0.672409746286929 0.672408232910328 1.0366680129325623e-06 -0.08085353971768205 -0.7391 0.6724195348506952 0.6724179995018118 1.0333971667830788e-06 -0.08085879938080108 -0.7392000000000001 0.6724293208352152 0.6724277635847828 1.0299026551585655e-06 -0.08086405775193921 -0.7393000000000001 0.6724391042387552 0.6724375251620649 1.0261852371740154e-06 -0.08086931483132985 -0.7394000000000001 0.6724488850595887 0.6724472842364737 1.0222457186293e-06 -0.08087457061920637 -0.7395 0.672458663295998 0.6724570408108164 1.0180849513707901e-06 -0.08087982511580218 -0.7396 0.6724684389462743 0.6724667948878906 1.0137038335411575e-06 -0.0808850783213506 -0.7397 0.6724782120087183 0.6724765464704852 1.0091033091630397e-06 -0.08089033023608508 -0.7398 0.6724879824816407 0.6724862955613775 1.0042843678614854e-06 -0.0808955808602389 -0.7399000000000001 0.6724977503633625 0.6724960421633361 9.992480449749763e-07 -0.08090083019404555 -0.74 0.6725075156522158 0.6725057862791177 9.939954209170487e-07 -0.0809060782377384 -0.7401 0.6725172783465436 0.672515527911468 9.885276212040495e-07 -0.0809113249915509 -0.7402000000000001 0.6725270384447011 0.6725252670631203 9.828458163441134e-07 -0.08091657045571644 -0.7403000000000001 0.6725367959450554 0.6725350037367959 9.769512212542963e-07 -0.08092181463046844 -0.7404000000000001 0.6725465508459867 0.672544737935203 9.708450950662861e-07 -0.08092705751604026 -0.7405 0.6725563031458877 0.6725544696610373 9.645287410153802e-07 -0.08093229911266542 -0.7406 0.672566052843165 0.6725641989169797 9.5800350616293e-07 -0.08093753942057723 -0.7407 0.6725757999362395 0.6725739257056982 9.512707810910292e-07 -0.08094277844000924 -0.7408 0.6725855444235463 0.6725836500298452 9.443319995972033e-07 -0.0809480161711948 -0.7409000000000001 0.6725952863035356 0.6725933718920583 9.371886381115413e-07 -0.08095325261436738 -0.741 0.6726050255746727 0.6726030912949602 9.298422158354747e-07 -0.08095848776976045 -0.7411 0.6726147622354388 0.6726128082411571 9.222942943254431e-07 -0.08096372163760743 -0.7412000000000001 0.6726244962843316 0.672622522733239 9.145464767157385e-07 -0.08096895421814178 -0.7413000000000001 0.6726342277198649 0.6726322347737792 9.066004081625945e-07 -0.08097418551159694 -0.7414000000000001 0.6726439565405699 0.672641944365334 8.984577747339628e-07 -0.08097941551820637 -0.7415 0.6726536827449954 0.6726516515104422 8.901203033817584e-07 -0.08098464423820358 -0.7416 0.6726634063317075 0.6726613562116239 8.815897618863477e-07 -0.08098987167182198 -0.7417 0.6726731272992914 0.6726710584713818 8.728679578018372e-07 -0.08099509781929506 -0.7418 0.6726828456463507 0.6726807582921988 8.639567386781177e-07 -0.08100032268085632 -0.7419000000000001 0.6726925613715076 0.672690455676539 8.548579913947307e-07 -0.08100554625673917 -0.742 0.6727022744734048 0.6727001506268474 8.455736417445348e-07 -0.08101076854717722 -0.7421 0.6727119849507042 0.6727098431455479 8.361056541700274e-07 -0.08101598955240383 -0.7422000000000001 0.672721692802088 0.6727195332350447 8.264560312082336e-07 -0.08102120927265252 -0.7423000000000001 0.6727313980262598 0.6727292208977215 8.166268131437615e-07 -0.08102642770815686 -0.7424000000000001 0.6727411006219433 0.6727389061359397 8.066200776479793e-07 -0.08103164485915025 -0.7425 0.6727508005878844 0.6727485889520401 7.964379391961485e-07 -0.08103686072586624 -0.7426 0.6727604979228506 0.6727582693483416 7.860825486649681e-07 -0.08104207530853835 -0.7427 0.6727701926256315 0.6727679473271397 7.75556092971752e-07 -0.08104728860740004 -0.7428 0.6727798846950392 0.6727776228907085 7.648607945609509e-07 -0.08105250062268486 -0.7429000000000001 0.6727895741299093 0.6727872960412984 7.539989107935297e-07 -0.0810577113546263 -0.743 0.6727992609290998 0.6727969667811369 7.429727337110448e-07 -0.08106292080345791 -0.7431 0.6728089450914929 0.6728066351124269 7.317845895221664e-07 -0.0810681289694132 -0.7432000000000001 0.6728186266159948 0.672816301037348 7.204368378393999e-07 -0.08107333585272566 -0.7433000000000001 0.6728283055015358 0.6728259645580552 7.089318715125525e-07 -0.08107854145362889 -0.7434000000000001 0.6728379817470709 0.6728356256766785 6.97272115920966e-07 -0.08108374577235633 -0.7435 0.6728476553515799 0.6728452843953229 6.854600286959611e-07 -0.08108894880914157 -0.7436 0.6728573263140686 0.672854940716068 6.734980987910255e-07 -0.08109415056421816 -0.7437 0.6728669946335675 0.6728645946409683 6.61388846356914e-07 -0.08109935103781962 -0.7438 0.6728766603091336 0.6728742461720512 6.491348221310256e-07 -0.08110455023017951 -0.7439000000000001 0.6728863233398503 0.6728838953113181 6.367386068267811e-07 -0.08110974814153138 -0.744 0.6728959837248268 0.6728935420607441 6.242028104536113e-07 -0.08111494477210873 -0.7441 0.6729056414632002 0.6729031864222775 6.115300720116457e-07 -0.08112014012214523 -0.7442000000000001 0.6729152965541336 0.6729128283978383 5.987230588394565e-07 -0.08112533419187432 -0.7443000000000001 0.6729249489968184 0.6729224679893199 5.857844661144584e-07 -0.08113052698152962 -0.7444000000000001 0.6729345987904735 0.6729321051985875 5.727170162145301e-07 -0.08113571849134465 -0.7445 0.6729442459343452 0.6729417400274784 5.595234581212694e-07 -0.08114090872155304 -0.7446 0.672953890427709 0.6729513724778019 5.462065668648819e-07 -0.08114609767238834 -0.7447 0.6729635322698683 0.6729610025513375 5.327691429551917e-07 -0.08115128534408407 -0.7448 0.6729731714601555 0.6729706302498369 5.192140119653077e-07 -0.08115647173687386 -0.7449000000000001 0.6729828079979316 0.6729802555750226 5.05544023574056e-07 -0.08116165685099128 -0.745 0.6729924418825876 0.672989878528587 4.917620512745469e-07 -0.08116684068666989 -0.7451 0.6730020731135431 0.6729994991121938 4.778709916247736e-07 -0.08117202324414328 -0.7452000000000001 0.6730117016902485 0.6730091173274764 4.6387376369250166e-07 -0.08117720452364509 -0.7453000000000001 0.6730213276121834 0.6730187331760378 4.497733084862787e-07 -0.08118238452540882 -0.7454000000000001 0.6730309508788574 0.6730283466594512 4.355725882199124e-07 -0.08118756324966815 -0.7455 0.6730405714898116 0.6730379577792592 4.2127458574348076e-07 -0.0811927406966566 -0.7456 0.6730501894446163 0.6730475665369737 4.0688230400209857e-07 -0.08119791686660782 -0.7457 0.6730598047428735 0.6730571729340757 3.923987652518224e-07 -0.08120309175975543 -0.7458 0.673069417384216 0.673066776972015 3.778270105184167e-07 -0.08120826537633297 -0.7459000000000001 0.6730790273683079 0.67307637865221 3.6317009899367036e-07 -0.08121343771657408 -0.746 0.6730886346948443 0.673085977976048 3.4843110734150695e-07 -0.08121860878071235 -0.7461 0.6730982393635518 0.6730955749448841 3.3361312899715667e-07 -0.08122377856898137 -0.7462000000000001 0.6731078413741896 0.6731051695600425 3.187192736814337e-07 -0.08122894708161485 -0.7463000000000001 0.6731174407265476 0.6731147618228142 3.03752666568069e-07 -0.08123411431884629 -0.7464000000000001 0.6731270374204483 0.6731243517344588 2.887164477563542e-07 -0.08123928028090935 -0.7465 0.6731366314557468 0.673133939296204 2.7361377154255795e-07 -0.0812444449680377 -0.7466 0.6731462228323293 0.6731435245092443 2.584478057676698e-07 -0.08124960838046491 -0.7467 0.6731558115501155 0.6731531073747419 2.432217311928997e-07 -0.08125477051842461 -0.7468 0.6731653976090575 0.6731626878938264 2.279387407988498e-07 -0.08125993138215042 -0.7469000000000001 0.6731749810091399 0.6731722660675946 2.1260203913325837e-07 -0.08126509097187601 -0.747 0.6731845617503799 0.6731818418971105 1.9721484160323266e-07 -0.08127024928783498 -0.7471 0.6731941398328279 0.6731914153834048 1.817803738507484e-07 -0.08127540633026095 -0.7472000000000001 0.6732037152565675 0.6732009865274752 1.6630187105529104e-07 -0.08128056209938761 -0.7473000000000001 0.673213288021715 0.6732105553302863 1.5078257726772182e-07 -0.08128571659544855 -0.7474000000000001 0.6732228581284202 0.6732201217927691 1.352257446955718e-07 -0.08129086981867742 -0.7475 0.6732324255768658 0.6732296859158218 1.196346330577247e-07 -0.08129602176930789 -0.7476 0.6732419903672682 0.6732392477003082 1.0401250888705804e-07 -0.08130117244757357 -0.7477 0.673251552499877 0.6732488071470597 8.836264484002321e-08 -0.08130632185370812 -0.7478 0.6732611119749756 0.6732583642568734 7.26883190339811e-08 -0.08131146998794521 -0.7479000000000001 0.6732706687928807 0.6732679190305126 5.699281433596548e-08 -0.08131661685051846 -0.748 0.6732802229539422 0.6732774714687078 4.127941768440613e-08 -0.08132176244166155 -0.7481 0.6732897744585441 0.6732870215721549 2.5551419403913034e-08 -0.08132690676160811 -0.7482000000000001 0.6732993233071038 0.6732965693415165 9.812112511387028e-09 -0.0813320498105918 -0.7483000000000001 0.6733088695000725 0.6733061147774215 -5.935207973532808e-09 -0.08133719158884631 -0.7484000000000001 0.6733184130379348 0.6733156578804645 -2.1687245717154358e-08 -0.0813423320966052 -0.7485 0.6733279539212094 0.6733251986512072 -3.7440703756080884e-08 -0.08134747133410228 -0.7486 0.673337492150448 0.6733347370901769 -5.319228519559986e-08 -0.08135260930157108 -0.7487 0.673347027726237 0.6733442731978673 -6.893869390015711e-08 -0.08135774599924539 -0.7488 0.6733565606491955 0.6733538069747378 -8.46766351758621e-08 -0.08136288142735877 -0.7489000000000001 0.6733660909199767 0.6733633384212152 -1.004028164696899e-07 -0.08136801558614495 -0.749 0.6733756185392673 0.6733728675376914 -1.1611394805204067e-07 -0.08137314847583763 -0.7491 0.6733851435077877 0.6733823943245253 -1.3180674370699696e-07 -0.08137828009667039 -0.7492000000000001 0.6733946658262913 0.6733919187820416 -1.4747792142361105e-07 -0.08138341044887692 -0.7493000000000001 0.673404185495566 0.6734014409105324 -1.6312420407504913e-07 -0.08138853953269101 -0.7494000000000001 0.6734137025164323 0.6734109607102552 -1.787423201116134e-07 -0.08139366734834622 -0.7495 0.6734232168897443 0.6734204781814341 -1.9432900424942723e-07 -0.08139879389607624 -0.7496 0.6734327286163894 0.6734299933242606 -2.0988099813656902e-07 -0.08140391917611475 -0.7497 0.6734422376972884 0.6734395061388923 -2.253950510573699e-07 -0.08140904318869552 -0.7498 0.673451744133395 0.6734490166254533 -2.408679205812003e-07 -0.0814141659340521 -0.7499000000000001 0.6734612479256963 0.6734585247840352 -2.562963732875845e-07 -0.08141928741241827 -0.75 0.6734707490752119 0.6734680306146961 -2.7167718539763963e-07 -0.08142440762402768 -0.7501 0.6734802475829944 0.6734775341174608 -2.870071434887822e-07 -0.08142952656911402 -0.7502000000000001 0.6734897434501296 0.673487035292322 -3.022830450810643e-07 -0.08143464424791098 -0.7503000000000001 0.6734992366777354 0.6734965341392393 -3.175016994663715e-07 -0.08143976066065226 -0.7504000000000001 0.6735087272669624 0.6735060306581393 -3.3265992820802337e-07 -0.0814448758075715 -0.7505 0.6735182152189937 0.673515524848917 -3.4775456590058207e-07 -0.08144998968890249 -0.7506 0.6735277005350441 0.6735250167114342 -3.627824608359864e-07 -0.08145510230487883 -0.7507 0.6735371832163612 0.6735345062455207 -3.777404755725411e-07 -0.0814602136557342 -0.7508 0.6735466632642242 0.6735439934509749 -3.926254877259505e-07 -0.08146532374170244 -0.7509000000000001 0.673556140679944 0.6735534783275623 -4.0743439048279706e-07 -0.08147043256301706 -0.751 0.6735656154648634 0.6735629608750175 -4.221640933707582e-07 -0.08147554011991193 -0.7511 0.6735750876203562 0.6735724410930429 -4.368115228622904e-07 -0.0814806464126206 -0.7512000000000001 0.6735845571478281 0.6735819189813099 -4.5137362295055716e-07 -0.08148575144137686 -0.7513000000000001 0.6735940240487154 0.6735913945394586 -4.6584735589189075e-07 -0.08149085520641436 -0.7514000000000001 0.6736034883244855 0.6736008677670982 -4.802297027609037e-07 -0.08149595770796686 -0.7515 0.6736129499766363 0.6736103386638067 -4.945176641235616e-07 -0.08150105894626801 -0.7516 0.6736224090066965 0.673619807229132 -5.087082606825e-07 -0.08150615892155152 -0.7517 0.6736318654162248 0.6736292734625915 -5.227985338251973e-07 -0.08151125763405115 -0.7518 0.67364131920681 0.673638737363672 -5.367855463039861e-07 -0.08151635508400051 -0.7519000000000001 0.6736507703800712 0.6736481989318308 -5.506663828813707e-07 -0.0815214512716334 -0.752 0.6736602189376562 0.6736576581664953 -5.64438150829627e-07 -0.08152654619718341 -0.7521 0.6736696648812429 0.6736671150670636 -5.780979806524478e-07 -0.08153163986088437 -0.7522000000000001 0.6736791082125386 0.6736765696329041 -5.916430265290318e-07 -0.08153673226296994 -0.7523000000000001 0.6736885489332786 0.6736860218633567 -6.050704671189955e-07 -0.0815418234036738 -0.7524000000000001 0.6736979870452273 0.6736954717577323 -6.183775059925845e-07 -0.0815469132832297 -0.7525 0.6737074225501778 0.6737049193153133 -6.315613723245628e-07 -0.08155200190187135 -0.7526 0.6737168554499506 0.6737143645353538 -6.4461932135218e-07 -0.08155708925983242 -0.7527 0.6737262857463947 0.6737238074170802 -6.575486349996718e-07 -0.08156217535734668 -0.7528 0.6737357134413863 0.6737332479596909 -6.703466224888821e-07 -0.08156726019464779 -0.7529000000000001 0.6737451385368289 0.6737426861623572 -6.830106208666198e-07 -0.08157234377196948 -0.753 0.6737545610346531 0.6737521220242231 -6.955379954903806e-07 -0.08157742608954544 -0.7531 0.6737639809368163 0.6737615555444061 -7.07926140722237e-07 -0.08158250714760942 -0.7532000000000001 0.673773398245302 0.6737709867219965 -7.201724804839493e-07 -0.0815875869463951 -0.7533000000000001 0.67378281296212 0.6737804155560593 -7.322744684928884e-07 -0.08159266548613622 -0.7534000000000001 0.673792225089306 0.6737898420456326 -7.442295891640915e-07 -0.08159774276706647 -0.7535 0.6738016346289211 0.67379926618973 -7.560353579155743e-07 -0.0816028187894196 -0.7536 0.6738110415830509 0.6738086879873391 -7.676893218067082e-07 -0.08160789355342932 -0.7537 0.6738204459538069 0.673818107437423 -7.791890599961881e-07 -0.0816129670593293 -0.7538 0.6738298477433242 0.6738275245389196 -7.90532184199999e-07 -0.0816180393073533 -0.7539000000000001 0.6738392469537626 0.6738369392907428 -8.017163392187721e-07 -0.081623110297735 -0.754 0.6738486435873057 0.6738463516917832 -8.127392035067738e-07 -0.08162818003070813 -0.7541 0.6738580376461598 0.6738557617409071 -8.235984895327286e-07 -0.08163324850650641 -0.7542000000000001 0.6738674291325554 0.673865169436958 -8.342919444043195e-07 -0.08163831572536356 -0.7543000000000001 0.6738768180487451 0.673874574778756 -8.448173501596212e-07 -0.08164338168751334 -0.7544000000000001 0.6738862043970036 0.6738839777650992 -8.551725243777231e-07 -0.08164844639318933 -0.7545 0.6738955881796285 0.6738933783947636 -8.653553205811848e-07 -0.08165350984262537 -0.7546 0.6739049693989384 0.6739027766665029 -8.753636286523703e-07 -0.08165857203605512 -0.7547 0.6739143480572732 0.67391217257905 -8.851953752914143e-07 -0.0816636329737123 -0.7548 0.6739237241569941 0.6739215661311171 -8.948485244741899e-07 -0.0816686926558307 -0.7549000000000001 0.6739330977004825 0.6739309573213943 -9.043210777714972e-07 -0.08167375108264396 -0.755 0.6739424686901397 0.6739403461485529 -9.136110750429527e-07 -0.08167880825438581 -0.7551 0.6739518371283874 0.6739497326112438 -9.227165945618898e-07 -0.08168386417128996 -0.7552000000000001 0.6739612030176657 0.6739591167080985 -9.316357534316921e-07 -0.08168891883359014 -0.7553000000000001 0.6739705663604345 0.6739684984377293 -9.403667080992717e-07 -0.08169397224152003 -0.7554000000000001 0.6739799271591721 0.6739778777987304 -9.489076546742581e-07 -0.0816990243953134 -0.7555 0.6739892854163743 0.673987254789677 -9.572568294702322e-07 -0.08170407529520392 -0.7556 0.673998641134555 0.6739966294091274 -9.654125089630927e-07 -0.08170912494142535 -0.7557 0.6740079943162455 0.6740060016556216 -9.733730106376015e-07 -0.08171417333421137 -0.7558 0.6740173449639937 0.6740153715276833 -9.8113669294575e-07 -0.0817192204737957 -0.7559000000000001 0.6740266930803643 0.6740247390238192 -9.887019560284038e-07 -0.08172426636041208 -0.756 0.6740360386679376 0.6740341041425201 -9.960672414655036e-07 -0.08172931099429416 -0.7561 0.6740453817293098 0.6740434668822608 -1.0032310333030203e-06 -0.0817343543756757 -0.7562000000000001 0.674054722267092 0.6740528272415016 -1.010191857830911e-06 -0.08173939650479041 -0.7563000000000001 0.6740640602839099 0.6740621852186869 -1.016948284165986e-06 -0.08174443738187195 -0.7564000000000001 0.6740733957824041 0.6740715408122477 -1.0234989244461978e-06 -0.08174947700715413 -0.7565 0.6740827287652287 0.6740808940206003 -1.0298424341914636e-06 -0.08175451538087058 -0.7566 0.6740920592350508 0.6740902448421481 -1.0359775124701986e-06 -0.08175955250325506 -0.7567 0.6741013871945509 0.6740995932752808 -1.0419029021768722e-06 -0.08176458837454122 -0.7568 0.6741107126464216 0.6741089393183761 -1.0476173905038522e-06 -0.0817696229949628 -0.7569000000000001 0.6741200355933681 0.6741182829697994 -1.0531198088303828e-06 -0.0817746563647535 -0.757 0.674129356038107 0.6741276242279043 -1.0584090333332075e-06 -0.08177968848414707 -0.7571 0.6741386739833655 0.6741369630910328 -1.0634839849033018e-06 -0.08178471935337717 -0.7572000000000001 0.6741479894318818 0.674146299557517 -1.0683436297287408e-06 -0.08178974897267753 -0.7573000000000001 0.6741573023864046 0.6741556336256782 -1.0729869790448987e-06 -0.08179477734228185 -0.7574000000000001 0.6741666128496917 0.674164965293828 -1.0774130897728273e-06 -0.08179980446242385 -0.7575 0.6741759208245107 0.674174294560268 -1.081621064380478e-06 -0.0818048303333372 -0.7576 0.6741852263136376 0.6741836214232919 -1.0856100512712796e-06 -0.08180985495525561 -0.7577 0.6741945293198572 0.6741929458811842 -1.0893792449506723e-06 -0.0818148783284128 -0.7578 0.6742038298459614 0.6742022679322218 -1.0929278861093739e-06 -0.08181990045304247 -0.7579000000000001 0.6742131278947503 0.6742115875746744 -1.0962552618731802e-06 -0.08182492132937831 -0.758 0.6742224234690302 0.6742209048068037 -1.0993607058029653e-06 -0.08182994095765402 -0.7581 0.6742317165716141 0.6742302196268659 -1.10224359808897e-06 -0.08183495933810328 -0.7582000000000001 0.6742410072053211 0.6742395320331107 -1.1049033657450913e-06 -0.08183997647095984 -0.7583000000000001 0.6742502953729756 0.6742488420237822 -1.1073394827754157e-06 -0.08184499235645733 -0.7584000000000001 0.6742595810774067 0.6742581495971196 -1.1095514699521747e-06 -0.08185000699482947 -0.7585 0.6742688643214486 0.6742674547513574 -1.1115388953986116e-06 -0.08185502038630998 -0.7586 0.6742781451079389 0.6742767574847259 -1.1133013742836706e-06 -0.08186003253113254 -0.7587 0.6742874234397195 0.6742860577954517 -1.1148385690717966e-06 -0.08186504342953085 -0.7588 0.6742966993196342 0.6742953556817585 -1.1161501894951797e-06 -0.08187005308173857 -0.7589000000000001 0.6743059727505303 0.6743046511418671 -1.1172359928313114e-06 -0.0818750614879894 -0.759 0.6743152437352569 0.6743139441739963 -1.1180957836531835e-06 -0.08188006864851705 -0.7591 0.6743245122766646 0.674323234776363 -1.1187294140513337e-06 -0.08188507456355519 -0.7592000000000001 0.674333778377605 0.6743325229471829 -1.119136783578334e-06 -0.08189007923333748 -0.7593000000000001 0.6743430420409307 0.6743418086846714 -1.1193178392487901e-06 -0.08189508265809765 -0.7594000000000001 0.674352303269494 0.674351091987043 -1.1192725759001654e-06 -0.08190008483806938 -0.7595 0.674361562066147 0.6743603728525132 -1.1190010354433788e-06 -0.08190508577348632 -0.7596 0.674370818433741 0.6743696512792972 -1.1185033076954731e-06 -0.08191008546458217 -0.7597 0.6743800723751259 0.6743789272656124 -1.1177795296579696e-06 -0.0819150839115906 -0.7598 0.67438932389315 0.6743882008096777 -1.1168298858221792e-06 -0.08192008111474533 -0.7599000000000001 0.6743985729906585 0.6743974719097138 -1.115654608307981e-06 -0.08192507707427997 -0.76 0.674407819670495 0.6744067405639442 -1.1142539764197323e-06 -0.08193007179042822 -0.7601 0.6744170639354988 0.674416006770596 -1.112628316785047e-06 -0.08193506526342374 -0.7602000000000001 0.674426305788506 0.6744252705278992 -1.1107780031605063e-06 -0.08194005749350022 -0.7603000000000001 0.6744355452323484 0.674434531834089 -1.10870345648717e-06 -0.08194504848089135 -0.7604000000000001 0.6744447822698527 0.6744437906874039 -1.1064051448073098e-06 -0.08195003822583075 -0.7605 0.6744540169038409 0.6744530470860887 -1.103883583125631e-06 -0.08195502672855214 -0.7606 0.6744632491371289 0.6744623010283929 -1.101139333103962e-06 -0.08196001398928911 -0.7607 0.6744724789725263 0.6744715525125724 -1.0981730032555426e-06 -0.08196500000827538 -0.7608 0.6744817064128368 0.6744808015368903 -1.0949852486119571e-06 -0.08196998478574463 -0.7609000000000001 0.6744909314608563 0.6744900480996152 -1.0915767706676238e-06 -0.08197496832193045 -0.761 0.6745001541193729 0.6744992921990243 -1.0879483171855053e-06 -0.08197995061706649 -0.7611 0.6745093743911676 0.6745085338334025 -1.0841006819750643e-06 -0.08198493167138649 -0.7612000000000001 0.6745185922790122 0.6745177730010433 -1.0800347048922632e-06 -0.08198991148512408 -0.7613000000000001 0.6745278077856693 0.6745270097002487 -1.0757512715342532e-06 -0.08199489005851283 -0.7614000000000001 0.6745370209138928 0.6745362439293306 -1.0712513130173296e-06 -0.08199986739178658 -0.7615 0.6745462316664252 0.6745454756866103 -1.0665358058659091e-06 -0.08200484348517878 -0.7616 0.6745554400460001 0.6745547049704192 -1.061605771845997e-06 -0.08200981833892315 -0.7617 0.6745646460553394 0.6745639317791001 -1.0564622776321198e-06 -0.08201479195325333 -0.7618 0.6745738496971542 0.6745731561110067 -1.0511064344742582e-06 -0.08201976432840298 -0.7619000000000001 0.6745830509741432 0.674582377964504 -1.04553939830887e-06 -0.0820247354646057 -0.762 0.6745922498889931 0.6745915973379701 -1.0397623692315339e-06 -0.08202970536209518 -0.7621 0.6746014464443782 0.6746008142297946 -1.033776591219393e-06 -0.082034674021105 -0.7622000000000001 0.6746106406429595 0.6746100286383805 -1.0275833521589117e-06 -0.08203964144186882 -0.7623000000000001 0.6746198324873842 0.674619240562145 -1.0211839831519853e-06 -0.08204460762462032 -0.7624000000000001 0.6746290219802856 0.6746284499995181 -1.0145798585992072e-06 -0.08204957256959308 -0.7625 0.6746382091242823 0.6746376569489445 -1.0077723958112905e-06 -0.08205453627702068 -0.7626000000000001 0.6746473939219786 0.6746468614088845 -1.0007630545927348e-06 -0.08205949874713687 -0.7627 0.6746565763759627 0.6746560633778125 -9.93553336908759e-07 -0.08206445998017521 -0.7628 0.6746657564888072 0.6746652628542188 -9.861447867465234e-07 -0.08206941997636924 -0.7629000000000001 0.6746749342630691 0.6746744598366105 -9.785389896987962e-07 -0.08207437873595264 -0.763 0.6746841097012879 0.6746836543235102 -9.707375727141532e-07 -0.082079336259159 -0.7631 0.6746932828059871 0.6746928463134587 -9.627422034308442e-07 -0.08208429254622202 -0.7632000000000001 0.6747024535796715 0.6747020358050131 -9.545545901767927e-07 -0.08208924759737526 -0.7633000000000001 0.6747116220248288 0.6747112227967487 -9.461764815255069e-07 -0.08209420141285231 -0.7634000000000001 0.6747207881439283 0.6747204072872586 -9.376096657964794e-07 -0.08209915399288682 -0.7635 0.6747299519394203 0.6747295892751549 -9.288559708747757e-07 -0.08210410533771234 -0.7636000000000001 0.6747391134137366 0.6747387687590685 -9.199172635865338e-07 -0.08210905544756252 -0.7637 0.674748272569289 0.6747479457376497 -9.107954495046755e-07 -0.08211400432267088 -0.7638 0.6747574294084695 0.6747571202095684 -9.014924724354278e-07 -0.08211895196327111 -0.7639000000000001 0.6747665839336499 0.6747662921735149 -8.920103140297453e-07 -0.08212389836959673 -0.764 0.6747757361471812 0.6747754616282005 -8.82350993366976e-07 -0.08212884354188141 -0.7641 0.6747848860513936 0.674784628572356 -8.725165665662837e-07 -0.08213378748035866 -0.7642 0.6747940336485956 0.6747937930047351 -8.625091262731699e-07 -0.08213873018526208 -0.7643000000000001 0.6748031789410742 0.674802954924112 -8.523308012708952e-07 -0.08214367165682528 -0.7644000000000001 0.674812321931094 0.6748121143292838 -8.419837560363908e-07 -0.08214861189528182 -0.7645 0.674821462620897 0.6748212712190695 -8.314701902267796e-07 -0.08215355090086529 -0.7646000000000001 0.6748306010127029 0.6748304255923111 -8.207923382491655e-07 -0.0821584886738093 -0.7647 0.6748397371087071 0.6748395774478733 -8.099524687887882e-07 -0.08216342521434732 -0.7648 0.6748488709110824 0.6748487267846449 -7.989528843649341e-07 -0.08216836052271298 -0.7649000000000001 0.6748580024219772 0.6748578736015383 -7.877959207897023e-07 -0.08217329459913986 -0.765 0.6748671316435159 0.6748670178974896 -7.764839466406492e-07 -0.08217822744386151 -0.7651 0.6748762585777979 0.6748761596714596 -7.650193629138435e-07 -0.08218315905711146 -0.7652 0.6748853832268984 0.6748852989224344 -7.534046023438545e-07 -0.08218808943912333 -0.7653000000000001 0.6748945055928663 0.6748944356494246 -7.416421288763964e-07 -0.08219301859013062 -0.7654000000000001 0.674903625677726 0.6749035698514667 -7.29734437335261e-07 -0.08219794651036688 -0.7655 0.6749127434834754 0.6749127015276226 -7.176840526867956e-07 -0.08220287320006574 -0.7656000000000001 0.6749218590120862 0.6749218306769806 -7.054935297623466e-07 -0.08220779865946064 -0.7657 0.6749309722655039 0.6749309572986549 -6.931654523839592e-07 -0.08221272288878519 -0.7658 0.674940083245647 0.6749400813917869 -6.807024331700884e-07 -0.08221764588827289 -0.7659000000000001 0.6749491919544071 0.6749492029555444 -6.681071126751759e-07 -0.08222256765815729 -0.766 0.6749582983936482 0.6749583219891229 -6.553821589871944e-07 -0.0822274881986719 -0.7661 0.6749674025652068 0.6749674384917451 -6.425302671586586e-07 -0.08223240751005026 -0.7662 0.6749765044708917 0.6749765524626619 -6.295541586098796e-07 -0.0822373255925259 -0.7663000000000001 0.6749856041124835 0.6749856639011518 -6.16456580587732e-07 -0.08224224244633238 -0.7664000000000001 0.6749947014917339 0.6749947728065218 -6.032403055411528e-07 -0.08224715807170319 -0.7665 0.6750037966103665 0.6750038791781074 -5.899081305243969e-07 -0.08225207246887184 -0.7666000000000001 0.6750128894700754 0.6750129830152732 -5.7646287673907e-07 -0.08225698563807186 -0.7667 0.675021980072526 0.6750220843174125 -5.629073887708502e-07 -0.08226189757953677 -0.7668 0.6750310684193541 0.6750311830839479 -5.492445339788654e-07 -0.08226680829350003 -0.7669000000000001 0.6750401545121659 0.6750402793143319 -5.354772020654819e-07 -0.08227171778019517 -0.767 0.6750492383525377 0.6750493730080459 -5.216083043407815e-07 -0.08227662603985568 -0.7671 0.6750583199420155 0.6750584641646025 -5.076407731535726e-07 -0.08228153307271506 -0.7672 0.6750673992821152 0.6750675527835435 -4.935775611836224e-07 -0.08228643887900679 -0.7673000000000001 0.6750764763743227 0.6750766388644414 -4.794216409212404e-07 -0.08229134345896438 -0.7674000000000001 0.675085551220092 0.6750857224068995 -4.651760040635944e-07 -0.0822962468128213 -0.7675 0.6750946238208473 0.6750948034105515 -4.508436607514321e-07 -0.08230114894081104 -0.7676000000000001 0.6751036941779812 0.6751038818750624 -4.3642763904172543e-07 -0.08230604984316708 -0.7677 0.6751127622928554 0.6751129578001279 -4.2193098420684194e-07 -0.08231094952012291 -0.7678 0.6751218281667998 0.6751220311854755 -4.0735675815167793e-07 -0.08231584797191195 -0.7679000000000001 0.6751308918011129 0.6751311020308638 -3.927080387128301e-07 -0.08232074519876774 -0.768 0.6751399531970612 0.6751401703360832 -3.779879190479729e-07 -0.08232564120092367 -0.7681 0.67514901235588 0.6751492361009559 -3.63199506948908e-07 -0.08233053597861326 -0.7682 0.6751580692787716 0.6751582993253359 -3.483459242240028e-07 -0.08233542953206993 -0.7683000000000001 0.6751671239669066 0.6751673600091093 -3.334303059904231e-07 -0.08234032186152712 -0.7684000000000001 0.6751761764214232 0.6751764181521946 -3.184558000843274e-07 -0.08234521296721832 -0.7685 0.6751852266434273 0.6751854737545426 -3.03425566311466e-07 -0.08235010284937694 -0.7686000000000001 0.6751942746339921 0.6751945268161361 -2.8834277583655865e-07 -0.08235499150823646 -0.7687 0.6752033203941582 0.6752035773369911 -2.7321061053797724e-07 -0.08235987894403025 -0.7688 0.6752123639249331 0.6752126253171555 -2.580322622652842e-07 -0.0823647651569918 -0.7689000000000001 0.675221405227292 0.6752216707567112 -2.4281093222167094e-07 -0.08236965014735456 -0.769 0.6752304443021766 0.6752307136557716 -2.275498302284351e-07 -0.0823745339153519 -0.7691 0.6752394811504956 0.6752397540144834 -2.122521741421135e-07 -0.08237941646121723 -0.7692 0.6752485157731248 0.675248791833027 -1.969211890912037e-07 -0.08238429778518401 -0.7693000000000001 0.675257548170907 0.6752578271116151 -1.8156010685513313e-07 -0.08238917788748563 -0.7694000000000001 0.6752665783446511 0.675266859850494 -1.6617216513567512e-07 -0.08239405676835554 -0.7695 0.6752756062951331 0.6752758900499427 -1.5076060688734572e-07 -0.08239893442802708 -0.7696000000000001 0.6752846320230954 0.6752849177102743 -1.353286796790254e-07 -0.0824038108667337 -0.7697 0.6752936555292475 0.6752939428318343 -1.1987963493935438e-07 -0.08240868608470878 -0.7698 0.6753026768142647 0.6753029654150022 -1.0441672732876273e-07 -0.0824135600821857 -0.7699000000000001 0.6753116958787893 0.6753119854601903 -8.894321400221283e-08 -0.08241843285939787 -0.77 0.6753207127234301 0.6753210029678448 -7.34623539829643e-08 -0.08242330441657868 -0.7701 0.6753297273487622 0.6753300179384447 -5.7977407422714344e-08 -0.08242817475396148 -0.7702 0.675338739755327 0.6753390303725031 -4.2491634945221804e-08 -0.08243304387177963 -0.7703000000000001 0.6753477499436329 0.6753480402705658 -2.700829694905673e-08 -0.08243791177026655 -0.7704000000000001 0.6753567579141546 0.6753570476332125 -1.153065292292671e-08 -0.08244277844965558 -0.7705 0.6753657636673331 0.6753660524610557 3.93803924105679e-09 -0.08244764391018006 -0.7706000000000001 0.675374767203576 0.6753750547547425 1.9394523934762598e-08 -0.08245250815207343 -0.7707 0.6753837685232578 0.6753840545149518 3.4835548515244064e-08 -0.08245737117556896 -0.7708 0.675392767626719 0.6753930517423966 5.0257863995484264e-08 -0.08246223298090005 -0.7709000000000001 0.675401764514267 0.675402046437823 6.565822572961177e-08 -0.0824670935683 -0.771 0.6754107591861761 0.6754110386020103 8.103339407990184e-08 -0.08247195293800215 -0.7711 0.6754197516426869 0.6754200282357714 9.63801351193394e-08 -0.08247681109023988 -0.7712 0.6754287418840073 0.6754290153399511 1.1169522131510012e-07 -0.0824816680252465 -0.7713000000000001 0.6754377299103114 0.6754379999154286 1.2697543216172447e-07 -0.08248652374325532 -0.7714000000000001 0.6754467157217409 0.675446981963115 1.4221755493051824e-07 -0.08249137824449969 -0.7715 0.6754556993184045 0.6754559614839547 1.5741838527844054e-07 -0.08249623152921293 -0.7716000000000001 0.6754646807003775 0.6754649384789246 1.7257472798709594e-07 -0.0825010835976283 -0.7717 0.6754736598677027 0.6754739129490347 1.8768339756988772e-07 -0.08250593444997915 -0.7718 0.6754826368203902 0.6754828848953273 2.0274121897978503e-07 -0.0825107840864988 -0.7719000000000001 0.6754916115584177 0.6754918543188769 2.1774502829280395e-07 -0.08251563250742049 -0.772 0.6755005840817305 0.6755008212207908 2.3269167334638574e-07 -0.08252047971297757 -0.7721 0.6755095543902412 0.6755097856022083 2.475780143951223e-07 -0.08252532570340335 -0.7722 0.6755185224838303 0.6755187474643005 2.624009247664816e-07 -0.08253017047893103 -0.7723000000000001 0.6755274883623466 0.6755277068082706 2.7715729154775826e-07 -0.08253501403979395 -0.7724000000000001 0.6755364520256065 0.6755366636353537 2.9184401623139067e-07 -0.08253985638622535 -0.7725 0.6755454134733954 0.6755456179468164 3.0645801539497253e-07 -0.08254469751845853 -0.7726000000000001 0.675554372705466 0.6755545697439569 3.2099622128412e-07 -0.08254953743672672 -0.7727 0.6755633297215409 0.6755635190281047 3.35455582506361e-07 -0.08255437614126322 -0.7728 0.67557228452131 0.6755724658006201 3.49833064641758e-07 -0.08255921363230126 -0.7729000000000001 0.6755812371044334 0.6755814100628948 3.6412565088822513e-07 -0.0825640499100741 -0.773 0.6755901874705397 0.675590351816351 3.78330342783173e-07 -0.08256888497481496 -0.7731 0.6755991356192266 0.6755992910624413 3.9244416061984255e-07 -0.08257371882675708 -0.7732 0.6756080815500618 0.6756082278026492 4.064641443285444e-07 -0.08257855146613371 -0.7733000000000001 0.6756170252625826 0.6756171620384879 4.203873539415648e-07 -0.08258338289317811 -0.7734000000000001 0.675625966756296 0.6756260937715008 4.3421087018991056e-07 -0.08258821310812348 -0.7735 0.6756349060306793 0.6756350230032611 4.4793179526658733e-07 -0.08259304211120302 -0.7736000000000001 0.6756438430851802 0.6756439497353712 4.615472532915055e-07 -0.08259786990264997 -0.7737 0.6756527779192167 0.6756528739694632 4.750543910053695e-07 -0.08260269648269754 -0.7738 0.6756617105321778 0.6756617957071976 4.88450378297034e-07 -0.0826075218515789 -0.7739000000000001 0.6756706409234239 0.6756707149502647 5.017324088418817e-07 -0.08261234600952727 -0.774 0.6756795690922861 0.6756796317003824 5.148977006569355e-07 -0.08261716895677586 -0.7741 0.6756884950380675 0.6756885459592974 5.279434967531138e-07 -0.08262199069355784 -0.7742 0.6756974187600429 0.6756974577287842 5.408670656070758e-07 -0.08262681122010639 -0.7743000000000001 0.6757063402574592 0.6757063670106453 5.536657018689883e-07 -0.08263163053665469 -0.7744000000000001 0.6757152595295357 0.6757152738067107 5.663367268898822e-07 -0.08263644864343586 -0.7745 0.6757241765754645 0.6757241781188376 5.788774891796189e-07 -0.08264126554068317 -0.7746000000000001 0.6757330913944104 0.6757330799489101 5.91285364962002e-07 -0.08264608122862976 -0.7747 0.6757420039855113 0.6757419792988388 6.035577589796892e-07 -0.08265089570750876 -0.7748 0.6757509143478786 0.6757508761705611 6.156921047301145e-07 -0.08265570897755327 -0.7749000000000001 0.675759822480598 0.6757597705660396 6.276858651732553e-07 -0.08266052103899647 -0.775 0.6757687283827287 0.6757686624872639 6.395365332867442e-07 -0.0826653318920715 -0.7751 0.6757776320533053 0.6757775519362479 6.51241632440569e-07 -0.08267014153701152 -0.7752 0.6757865334913361 0.6757864389150313 6.627987169799399e-07 -0.08267494997404964 -0.7753000000000001 0.6757954326958049 0.6757953234256786 6.742053728775455e-07 -0.08267975720341898 -0.7754000000000001 0.675804329665671 0.6758042054702782 6.854592180666197e-07 -0.08268456322535267 -0.7755 0.6758132243998691 0.6758130850509431 6.965579029682978e-07 -0.08268936804008378 -0.7756000000000001 0.6758221168973104 0.67582196216981 7.074991110050943e-07 -0.08269417164784547 -0.7757000000000001 0.6758310071568819 0.6758308368290393 7.182805592392816e-07 -0.08269897404887078 -0.7758 0.6758398951774482 0.6758397090308144 7.288999984839117e-07 -0.08270377524339287 -0.7759000000000001 0.6758487809578504 0.6758485787773411 7.393552141077286e-07 -0.08270857523164477 -0.776 0.6758576644969073 0.675857446070848 7.496440264515014e-07 -0.08271337401385961 -0.7761 0.6758665457934154 0.6758663109135854 7.597642911472136e-07 -0.08271817159027048 -0.7762 0.6758754248461494 0.6758751733078259 7.697138995899078e-07 -0.08272296796111038 -0.7763000000000001 0.6758843016538625 0.6758840332558624 7.794907796315753e-07 -0.08272776312661234 -0.7764000000000001 0.6758931762152871 0.6758928907600099 7.890928954978893e-07 -0.08273255708700954 -0.7765 0.6759020485291349 0.6759017458226031 7.985182488290388e-07 -0.08273734984253497 -0.7766000000000001 0.6759109185940972 0.6759105984459974 8.077648786658509e-07 -0.0827421413934217 -0.7767000000000001 0.6759197864088452 0.6759194486325677 8.16830861907758e-07 -0.08274693173990276 -0.7768 0.6759286519720309 0.6759282963847082 8.257143140066869e-07 -0.08275172088221118 -0.7769000000000001 0.675937515282287 0.6759371417048321 8.344133889670591e-07 -0.08275650882058 -0.777 0.6759463763382279 0.6759459845953717 8.429262799425352e-07 -0.08276129555524227 -0.7771 0.6759552351384486 0.6759548250587766 8.512512196939825e-07 -0.08276608108643092 -0.7772 0.6759640916815275 0.6759636630975152 8.593864807698859e-07 -0.08277086541437906 -0.7773000000000001 0.6759729459660246 0.6759724987140723 8.673303759643147e-07 -0.08277564853931962 -0.7774000000000001 0.6759817979904832 0.6759813319109501 8.750812586777457e-07 -0.08278043046148559 -0.7775 0.6759906477534305 0.6759901626906675 8.826375231807404e-07 -0.08278521118111004 -0.7776000000000001 0.6759994952533763 0.6759989910557592 8.899976049470126e-07 -0.08278999069842591 -0.7777000000000001 0.6760083404888154 0.6760078170087759 8.971599813334397e-07 -0.08279476901366621 -0.7778 0.6760171834582269 0.6760166405522828 9.041231712469955e-07 -0.08279954612706383 -0.7779 0.6760260241600752 0.676025461688861 9.108857360606848e-07 -0.08280432203885185 -0.778 0.6760348625928099 0.676034280421105 9.174462794747651e-07 -0.08280909674926316 -0.7781 0.6760436987548666 0.676043096751624 9.238034480718582e-07 -0.0828138702585307 -0.7782 0.6760525326446676 0.6760519106830403 9.299559315389949e-07 -0.08281864256688747 -0.7783000000000001 0.6760613642606215 0.6760607222179893 9.359024629451707e-07 -0.08282341367456636 -0.7784000000000001 0.6760701936011247 0.6760695313591192 9.416418187968567e-07 -0.08282818358180037 -0.7785 0.6760790206645613 0.6760783381090898 9.471728196763785e-07 -0.08283295228882241 -0.7786000000000001 0.676087845449303 0.6760871424705733 9.524943302419153e-07 -0.08283771979586539 -0.7787000000000001 0.6760966679537103 0.6760959444462529 9.576052594495454e-07 -0.08284248610316221 -0.7788 0.6761054881761331 0.6761047440388226 9.625045608308014e-07 -0.08284725121094585 -0.7789 0.6761143061149109 0.6761135412509865 9.67191232770226e-07 -0.08285201511944917 -0.779 0.6761231217683725 0.6761223360854587 9.71664318699661e-07 -0.08285677782890502 -0.7791 0.676131935134838 0.6761311285449628 9.759229070982478e-07 -0.08286153933954632 -0.7792 0.6761407462126177 0.6761399186322314 9.79966131881005e-07 -0.08286629965160597 -0.7793000000000001 0.6761495550000138 0.6761487063500053 9.837931726763838e-07 -0.0828710587653168 -0.7794000000000001 0.6761583614953204 0.6761574917010336 9.874032545487132e-07 -0.08287581668091171 -0.7795 0.6761671656968238 0.6761662746880732 9.907956487753555e-07 -0.08288057339862365 -0.7796000000000001 0.6761759676028031 0.676175055313887 9.939696724303726e-07 -0.08288532891868534 -0.7797000000000001 0.6761847672115306 0.6761838335812456 9.969246889118821e-07 -0.08289008324132975 -0.7798 0.6761935645212722 0.6761926094929251 9.99660107969813e-07 -0.08289483636678964 -0.7799 0.6762023595302883 0.6762013830517074 1.0021753855116167e-06 -0.08289958829529781 -0.78 0.6762111522368339 0.6762101542603796 1.0044700243239113e-06 -0.08290433902708715 -0.7801 0.6762199426391597 0.6762189231217335 1.0065435737116601e-06 -0.0829090885623905 -0.7802 0.6762287307355116 0.676227689638565 1.008395629636949e-06 -0.08291383690144068 -0.7803000000000001 0.6762375165241317 0.6762364538136739 1.0100258349687863e-06 -0.0829185840444705 -0.7804000000000001 0.6762463000032586 0.6762452156498631 1.0114338793720812e-06 -0.08292332999171276 -0.7805 0.676255081171128 0.6762539751499379 1.0126194994741766e-06 -0.0829280747434002 -0.7806000000000001 0.6762638600259736 0.6762627323167065 1.013582479031383e-06 -0.08293281829976566 -0.7807000000000001 0.6762726365660268 0.6762714871529787 1.0143226486514223e-06 -0.08293756066104191 -0.7808 0.6762814107895179 0.6762802396615653 1.0148398861542507e-06 -0.0829423018274617 -0.7809 0.6762901826946759 0.6762889898452782 1.0151341163500138e-06 -0.08294704179925787 -0.781 0.6762989522797294 0.6762977377069295 1.0152053111500692e-06 -0.08295178057666307 -0.7811 0.6763077195429075 0.6763064832493313 1.0150534896224972e-06 -0.08295651815991012 -0.7812 0.6763164844824394 0.676315226475295 1.0146787179088346e-06 -0.08296125454923181 -0.7813000000000001 0.6763252470965548 0.6763239673876309 1.0140811091963187e-06 -0.0829659897448608 -0.7814000000000001 0.6763340073834863 0.6763327059891477 1.0132608237178875e-06 -0.08297072374702989 -0.7815 0.6763427653414666 0.6763414422826517 1.0122180687244242e-06 -0.08297545655597174 -0.7816000000000001 0.6763515209687324 0.6763501762709474 1.010953098484757e-06 -0.08298018817191916 -0.7817000000000001 0.6763602742635226 0.6763589079568353 1.0094662141191257e-06 -0.08298491859510475 -0.7818 0.6763690252240795 0.6763676373431131 1.0077577635714263e-06 -0.08298964782576128 -0.7819 0.6763777738486493 0.676376364432574 1.0058281414426773e-06 -0.0829943758641214 -0.782 0.6763865201354828 0.6763850892280072 1.0036777892685755e-06 -0.08299910271041784 -0.7821 0.6763952640828358 0.6763938117321964 1.0013071947978514e-06 -0.08300382836488329 -0.7822 0.6764040056889687 0.6764025319479204 9.987168924363576e-07 -0.0830085528277504 -0.7823000000000001 0.6764127449521483 0.6764112498779518 9.959074628862474e-07 -0.08301327609925188 -0.7824000000000001 0.6764214818706472 0.6764199655250565 9.928795332292406e-07 -0.08301799817962029 -0.7825 0.6764302164427454 0.676428678891994 9.89633776399268e-07 -0.08302271906908835 -0.7826000000000001 0.6764389486667296 0.6764373899815163 9.861709113212491e-07 -0.08302743876788872 -0.7827000000000001 0.6764476785408944 0.6764460987963674 9.824917026890478e-07 -0.08303215727625403 -0.7828 0.6764564060635425 0.6764548053392834 9.785969608822054e-07 -0.08303687459441692 -0.7829 0.6764651312329852 0.6764635096129914 9.744875414940957e-07 -0.08304159072260997 -0.783 0.676473854047543 0.676472211620209 9.701643456927478e-07 -0.08304630566106583 -0.7831 0.6764825745055456 0.6764809113636446 9.656283194436899e-07 -0.08305101941001707 -0.7832 0.6764912926053332 0.6764896088459962 9.60880453648727e-07 -0.08305573196969629 -0.7833000000000001 0.6765000083452564 0.6764983040699515 9.559217838683853e-07 -0.08306044334033615 -0.7834000000000001 0.6765087217236762 0.6765069970381865 9.507533898778231e-07 -0.08306515352216914 -0.7835 0.6765174327389656 0.6765156877533662 9.453763958611194e-07 -0.0830698625154279 -0.7836000000000001 0.6765261413895094 0.6765243762181439 9.397919699116741e-07 -0.083074570320345 -0.7837000000000001 0.6765348476737041 0.6765330624351598 9.340013236713851e-07 -0.08307927693715299 -0.7838 0.6765435515899597 0.6765417464070413 9.280057123028929e-07 -0.08308398236608439 -0.7839 0.676552253136699 0.676550428136403 9.218064339899801e-07 -0.08308868660737179 -0.784 0.6765609523123584 0.6765591076258457 9.154048300208384e-07 -0.08309338966124775 -0.7841 0.6765696491153883 0.6765677848779552 9.088022839554011e-07 -0.08309809152794473 -0.7842 0.6765783435442541 0.6765764598953035 9.020002219861656e-07 -0.08310279220769531 -0.7843000000000001 0.6765870355974355 0.6765851326804474 8.950001120500151e-07 -0.083107491700732 -0.7844000000000001 0.6765957252734276 0.676593803235928 8.878034638282184e-07 -0.08311219000728728 -0.7845 0.6766044125707419 0.6766024715642704 8.80411828302341e-07 -0.08311688712759364 -0.7846000000000001 0.6766130974879054 0.676611137667984 8.728267976154669e-07 -0.08312158306188362 -0.7847000000000001 0.6766217800234622 0.6766198015495604 8.650500042950426e-07 -0.08312627781038966 -0.7848 0.6766304601759731 0.676628463211475 8.570831213500218e-07 -0.08313097137334423 -0.7849 0.6766391379440166 0.6766371226561851 8.489278619655538e-07 -0.08313566375097982 -0.785 0.676647813326189 0.6766457798861303 8.405859785454162e-07 -0.08314035494352888 -0.7851 0.6766564863211048 0.6766544349037313 8.320592628785484e-07 -0.08314504495122386 -0.7852 0.6766651569273976 0.6766630877113906 8.233495457643514e-07 -0.08314973377429724 -0.7853000000000001 0.6766738251437192 0.6766717383114913 8.144586961383871e-07 -0.08315442141298142 -0.7854000000000001 0.6766824909687417 0.6766803867063969 8.053886211140115e-07 -0.08315910786750882 -0.7855 0.6766911544011565 0.6766890328984505 7.96141265607675e-07 -0.0831637931381119 -0.7856000000000001 0.6766998154396755 0.6766976768899755 7.867186114229874e-07 -0.08316847722502306 -0.7857000000000001 0.6767084740830311 0.6767063186832745 7.771226775005191e-07 -0.08317316012847467 -0.7858 0.6767171303299766 0.6767149582806282 7.673555189324777e-07 -0.08317784184869911 -0.7859 0.6767257841792871 0.6767235956842969 7.574192269349522e-07 -0.08318252238592883 -0.786 0.6767344356297589 0.6767322308965183 7.473159279874908e-07 -0.08318720174039619 -0.7861 0.6767430846802104 0.6767408639195083 7.370477837914668e-07 -0.08319187991233354 -0.7862 0.6767517313294826 0.6767494947554595 7.266169905761899e-07 -0.08319655690197318 -0.7863000000000001 0.6767603755764396 0.676758123406543 7.160257785715496e-07 -0.08320123270954759 -0.7864000000000001 0.6767690174199684 0.6767667498749051 7.052764117582155e-07 -0.08320590733528904 -0.7865 0.6767776568589791 0.6767753741626693 6.943711872292591e-07 -0.08321058077942983 -0.7866000000000001 0.6767862938924061 0.6767839962719353 6.833124347044306e-07 -0.0832152530422024 -0.7867000000000001 0.6767949285192078 0.6767926162047779 6.721025161693372e-07 -0.08321992412383902 -0.7868 0.6768035607383671 0.6768012339632477 6.607438251537978e-07 -0.08322459402457197 -0.7869 0.6768121905488915 0.6768098495493701 6.492387863710203e-07 -0.08322926274463355 -0.787 0.6768208179498141 0.6768184629651455 6.375898551069792e-07 -0.08323393028425607 -0.7871 0.6768294429401929 0.6768270742125492 6.257995169151043e-07 -0.08323859664367184 -0.7872 0.6768380655191115 0.6768356832935295 6.138702868113688e-07 -0.08324326182311309 -0.7873000000000001 0.6768466856856807 0.6768442902100095 6.018047088995893e-07 -0.08324792582281217 -0.7874000000000001 0.6768553034390363 0.6768528949638852 5.896053558163139e-07 -0.08325258864300127 -0.7875 0.6768639187783416 0.6768614975570264 5.772748280924445e-07 -0.08325725028391268 -0.7876000000000001 0.6768725317027859 0.6768700979912755 5.648157536675136e-07 -0.08326191074577863 -0.7877000000000001 0.6768811422115866 0.6768786962684477 5.522307873623289e-07 -0.08326657002883131 -0.7878000000000001 0.6768897503039879 0.6768872923903305 5.395226102544726e-07 -0.083271228133303 -0.7879 0.6768983559792618 0.6768958863586839 5.26693929178701e-07 -0.08327588505942585 -0.788 0.6769069592367091 0.6769044781752396 5.137474761024441e-07 -0.08328054080743216 -0.7881 0.6769155600756578 0.6769130678417005 5.006860074735497e-07 -0.08328519537755408 -0.7882 0.6769241584954645 0.6769216553597415 4.875123037623164e-07 -0.08328984877002378 -0.7883000000000001 0.6769327544955153 0.6769302407310083 4.742291688369926e-07 -0.08329450098507346 -0.7884000000000001 0.6769413480752242 0.676938823957118 4.6083942931152144e-07 -0.0832991520229353 -0.7885 0.6769499392340355 0.676947405039658 4.473459340598174e-07 -0.08330380188384147 -0.7886 0.6769585279714221 0.676955983980186 4.337515534524883e-07 -0.08330845056802415 -0.7887000000000001 0.6769671142868868 0.67696456078023 4.2005917877396826e-07 -0.08331309807571544 -0.7888000000000001 0.6769756981799621 0.6769731354412883 4.0627172182006177e-07 -0.08331774440714744 -0.7889 0.6769842796502108 0.6769817079648293 3.9239211399588747e-07 -0.0833223895625524 -0.789 0.6769928586972257 0.6769902783522899 3.784233059203612e-07 -0.08332703354216235 -0.7891 0.6770014353206301 0.6769988466050774 3.6436826659352883e-07 -0.08333167634620942 -0.7892 0.6770100095200781 0.6770074127245682 3.502299829316602e-07 -0.08333631797492569 -0.7893000000000001 0.6770185812952543 0.6770159767121076 3.360114591011154e-07 -0.08334095842854329 -0.7894000000000001 0.6770271506458744 0.6770245385690099 3.217157157620054e-07 -0.08334559770729429 -0.7895 0.6770357175716853 0.6770330982965579 3.073457895894083e-07 -0.08335023581141075 -0.7896 0.6770442820724651 0.6770416558960033 2.929047325517242e-07 -0.08335487274112473 -0.7897000000000001 0.6770528441480238 0.6770502113685661 2.783956112584196e-07 -0.08335950849666834 -0.7898000000000001 0.6770614037982021 0.6770587647154346 2.6382150628001533e-07 -0.08336414307827356 -0.7899 0.6770699610228734 0.6770673159377649 2.49185511613792e-07 -0.08336877648617247 -0.79 0.677078515821942 0.6770758650366814 2.344907338650004e-07 -0.08337340872059706 -0.7901 0.6770870681953451 0.6770844120132766 2.1974029174726128e-07 -0.0833780397817794 -0.7902 0.6770956181430516 0.6770929568686105 2.0493731528459236e-07 -0.08338266966995149 -0.7903000000000001 0.6771041656650624 0.6771014996037107 1.9008494524935804e-07 -0.08338729838534527 -0.7904000000000001 0.6771127107614111 0.6771100402195722 1.7518633242674664e-07 -0.0833919259281928 -0.7905 0.6771212534321636 0.6771185787171581 1.6024463694863655e-07 -0.08339655229872604 -0.7906 0.6771297936774181 0.677127115097398 1.4526302772807642e-07 -0.08340117749717697 -0.7907000000000001 0.6771383314973058 0.6771356493611892 1.3024468163355674e-07 -0.08340580152377754 -0.7908000000000001 0.6771468668919904 0.6771441815093961 1.1519278294430668e-07 -0.08341042437875971 -0.7909 0.6771553998616685 0.6771527115428503 1.0011052258007691e-07 -0.0834150460623554 -0.791 0.6771639304065691 0.6771612394623505 8.500109748357798e-08 -0.0834196665747966 -0.7911 0.6771724585269543 0.6771697652686622 6.986770991618263e-08 -0.0834242859163152 -0.7912 0.6771809842231192 0.6771782889625182 5.471356681260864e-08 -0.08342890408714314 -0.7913000000000001 0.677189507495392 0.6771868105446176 3.95418790471308e-08 -0.08343352108751226 -0.7914000000000001 0.6771980283441335 0.6771953300156269 2.4355860798672135e-08 -0.08343813691765453 -0.7915 0.6772065467697379 0.6772038473761792 9.158728851710318e-09 -0.08344275157780184 -0.7916 0.6772150627726322 0.6772123626268745 -6.046298081999191e-09 -0.08344736506818601 -0.7917000000000001 0.6772235763532768 0.6772208757682795 -2.1256000054710456e-08 -0.08345197738903898 -0.7918000000000001 0.6772320875121646 0.6772293868009279 -3.646715654058094e-08 -0.08345658854059254 -0.7919 0.6772405962498219 0.67723789572532 -5.167654714587815e-08 -0.08346119852307858 -0.792 0.6772491025668084 0.6772464025419228 -6.688095227289081e-08 -0.08346580733672891 -0.7921 0.6772576064637164 0.6772549072511702 -8.207715380872255e-08 -0.08347041498177536 -0.7922 0.677266107941171 0.6772634098534636 -9.72619358056287e-08 -0.08347502145844979 -0.7923000000000001 0.6772746069998312 0.6772719103491702 -1.1243208515761272e-07 -0.083479626766984 -0.7924000000000001 0.6772831036403882 0.6772804087386248 -1.275843922940445e-07 -0.08348423090760979 -0.7925 0.6772915978635664 0.6772889050221288 -1.427156518414574e-07 -0.08348883388055894 -0.7926 0.6773000896701231 0.6772973991999506 -1.5782266330963135e-07 -0.08349343568606322 -0.7927000000000001 0.6773085790608485 0.6773058912723258 -1.7290223178548225e-07 -0.08349803632435443 -0.7928000000000001 0.677317066036565 0.6773143812394571 -1.8795116856623606e-07 -0.08350263579566433 -0.7929 0.6773255505981286 0.6773228691015141 -2.029662918776043e-07 -0.08350723410022465 -0.793 0.6773340327464272 0.677331354858634 -2.1794442754338728e-07 -0.08351183123826712 -0.7931 0.6773425124823815 0.677339838510921 -2.3288240962732187e-07 -0.0835164272100235 -0.7932 0.677350989806945 0.6773483200584475 -2.4777708112003194e-07 -0.08352102201572553 -0.7933000000000001 0.6773594647211026 0.6773567995012524 -2.626252946155705e-07 -0.08352561565560492 -0.7934000000000001 0.6773679372258725 0.6773652768393423 -2.774239129602063e-07 -0.08353020812989331 -0.7935 0.6773764073223045 0.6773737520726925 -2.921698099359049e-07 -0.08353479943882246 -0.7936 0.6773848750114801 0.6773822252012449 -3.0685987090911526e-07 -0.08353938958262397 -0.7937000000000001 0.6773933402945136 0.6773906962249105 -3.21490993493434e-07 -0.08354397856152962 -0.7938000000000001 0.6774018031725502 0.6773991651435675 -3.3606008816716715e-07 -0.08354856637577096 -0.7939 0.6774102636467673 0.6774076319570632 -3.5056407902966935e-07 -0.08355315302557975 -0.794 0.6774187217183733 0.6774160966652123 -3.649999043148222e-07 -0.08355773851118754 -0.7941 0.6774271773886086 0.6774245592677992 -3.793645171473736e-07 -0.08356232283282607 -0.7942 0.6774356306587438 0.6774330197645758 -3.936548861327438e-07 -0.08356690599072686 -0.7943000000000001 0.6774440815300813 0.6774414781552637 -4.0786799603703683e-07 -0.08357148798512154 -0.7944000000000001 0.6774525300039542 0.6774499344395533 -4.2200084834909113e-07 -0.08357606881624174 -0.7945 0.6774609760817258 0.6774583886171037 -4.3605046203681885e-07 -0.08358064848431901 -0.7946 0.6774694197647906 0.6774668406875446 -4.500138740329285e-07 -0.08358522698958498 -0.7947000000000001 0.677477861054573 0.677475290650474 -4.6388813997738643e-07 -0.08358980433227121 -0.7948000000000001 0.6774862999525271 0.6774837385054603 -4.776703347933453e-07 -0.08359438051260924 -0.7949 0.6774947364601377 0.6774921842520418 -4.91357553270011e-07 -0.08359895553083063 -0.795 0.6775031705789185 0.6775006278897271 -5.049469107426541e-07 -0.08360352938716689 -0.7951 0.6775116023104134 0.6775090694179952 -5.184355437032329e-07 -0.08360810208184963 -0.7952 0.6775200316561949 0.6775175088362954 -5.318206102722378e-07 -0.0836126736151103 -0.7953000000000001 0.6775284586178646 0.677525946144048 -5.450992910382979e-07 -0.08361724398718041 -0.7954000000000001 0.6775368831970532 0.6775343813406449 -5.582687893773697e-07 -0.08362181319829148 -0.7955 0.6775453053954199 0.6775428144254485 -5.713263322715267e-07 -0.08362638124867501 -0.7956 0.6775537252146517 0.6775512453977934 -5.842691707669267e-07 -0.08363094813856244 -0.7957000000000001 0.6775621426564642 0.6775596742569858 -5.970945806260675e-07 -0.08363551386818524 -0.7958000000000001 0.6775705577226006 0.6775681010023039 -6.097998628412649e-07 -0.08364007843777488 -0.7959 0.6775789704148314 0.6775765256329985 -6.22382344231398e-07 -0.08364464184756282 -0.796 0.6775873807349546 0.6775849481482927 -6.348393779831429e-07 -0.08364920409778048 -0.7961 0.6775957886847954 0.6775933685473828 -6.471683442754728e-07 -0.0836537651886593 -0.7962 0.6776041942662048 0.6776017868294382 -6.593666507792584e-07 -0.08365832512043064 -0.7963000000000001 0.6776125974810611 0.6776102029936018 -6.714317331568687e-07 -0.08366288389332599 -0.7964000000000001 0.6776209983312682 0.67761861703899 -6.833610557144265e-07 -0.08366744150757668 -0.7965 0.6776293968187559 0.6776270289646935 -6.951521118597759e-07 -0.08367199796341407 -0.7966 0.6776377929454798 0.6776354387697774 -7.068024246437155e-07 -0.08367655326106957 -0.7967000000000001 0.6776461867134203 0.6776438464532812 -7.183095473012324e-07 -0.08368110740077453 -0.7968000000000001 0.6776545781245829 0.6776522520142201 -7.296710637094694e-07 -0.08368566038276035 -0.7969 0.6776629671809975 0.6776606554515838 -7.408845890538585e-07 -0.08369021220725831 -0.797 0.6776713538847183 0.6776690567643378 -7.519477700779209e-07 -0.08369476287449971 -0.7971 0.6776797382378235 0.6776774559514238 -7.62858285846546e-07 -0.08369931238471595 -0.7972 0.677688120242415 0.6776858530117597 -7.736138480235466e-07 -0.08370386073813832 -0.7973000000000001 0.6776964999006174 0.6776942479442399 -7.842122014128927e-07 -0.08370840793499806 -0.7974000000000001 0.6777048772145784 0.6777026407477363 -7.946511246109678e-07 -0.08371295397552653 -0.7975 0.6777132521864686 0.6777110314210975 -8.049284301453463e-07 -0.08371749885995491 -0.7976 0.6777216248184803 0.6777194199631498 -8.150419652519503e-07 -0.08372204258851448 -0.7977000000000001 0.6777299951128279 0.6777278063726979 -8.249896120415823e-07 -0.08372658516143655 -0.7978000000000001 0.6777383630717475 0.6777361906485252 -8.347692881521818e-07 -0.08373112657895238 -0.7979 0.6777467286974956 0.6777445727893929 -8.44378947137403e-07 -0.08373566684129313 -0.798 0.6777550919923498 0.6777529527940422 -8.538165789245822e-07 -0.08374020594869003 -0.7981 0.6777634529586081 0.6777613306611936 -8.630802101478041e-07 -0.08374474390137428 -0.7982 0.6777718115985885 0.6777697063895476 -8.721679046058695e-07 -0.08374928069957717 -0.7983000000000001 0.677780167914628 0.6777780799777844 -8.810777636231171e-07 -0.08375381634352977 -0.7984000000000001 0.6777885219090836 0.6777864514245657 -8.898079266461689e-07 -0.0837583508334633 -0.7985 0.6777968735843305 0.6777948207285338 -8.983565713965858e-07 -0.08376288416960892 -0.7986 0.6778052229427624 0.6778031878883126 -9.067219142316896e-07 -0.08376741635219775 -0.7987000000000001 0.6778135699867913 0.6778115529025084 -9.149022107968197e-07 -0.08377194738146104 -0.7988000000000001 0.6778219147188466 0.6778199157697088 -9.228957561779882e-07 -0.08377647725762985 -0.7989 0.6778302571413741 0.6778282764884843 -9.307008853320919e-07 -0.08378100598093523 -0.799 0.6778385972568377 0.6778366350573892 -9.383159733367119e-07 -0.08378553355160832 -0.7991 0.6778469350677169 0.6778449914749609 -9.457394358203253e-07 -0.0837900599698803 -0.7992 0.6778552705765071 0.6778533457397209 -9.529697291982275e-07 -0.08379458523598221 -0.7993000000000001 0.6778636037857195 0.6778616978501748 -9.600053513525442e-07 -0.08379910935014513 -0.7994000000000001 0.6778719346978798 0.6778700478048131 -9.668448413824304e-07 -0.0838036323126001 -0.7995 0.6778802633155288 0.6778783956021115 -9.734867803812275e-07 -0.08380815412357814 -0.7996 0.6778885896412215 0.6778867412405316 -9.799297913115623e-07 -0.08381267478331036 -0.7997000000000001 0.6778969136775268 0.6778950847185208 -9.86172539713115e-07 -0.08381719429202777 -0.7998000000000001 0.6779052354270263 0.6779034260345131 -9.922137338413961e-07 -0.08382171264996136 -0.7999 0.677913554892315 0.6779117651869295 -9.980521247232588e-07 -0.08382622985734213 -0.8 0.6779218720760005 0.6779201021741789 -1.0036865067675205e-06 -0.08383074591440114 -0.8001 0.6779301869807018 0.6779284369946572 -1.00911571759843e-06 -0.08383526082136933 -0.8002 0.6779384996090501 0.6779367696467491 -1.0143386387773123e-06 -0.08383977457847763 -0.8003000000000001 0.677946809963687 0.6779451001288279 -1.0193541956360352e-06 -0.08384428718595703 -0.8004000000000001 0.6779551180472654 0.6779534284392565 -1.0241613576655872e-06 -0.08384879864403853 -0.8005 0.677963423862448 0.6779617545763872 -1.0287591387658779e-06 -0.08385330895295301 -0.8006 0.6779717274119073 0.677970078538562 -1.0331465974122711e-06 -0.08385781811293137 -0.8007000000000001 0.6779800286983251 0.6779784003241145 -1.0373228367943632e-06 -0.08386232612420459 -0.8008000000000001 0.6779883277243921 0.6779867199313685 -1.0412870050380274e-06 -0.08386683298700355 -0.8009000000000001 0.6779966244928073 0.6779950373586394 -1.0450382955107251e-06 -0.08387133870155912 -0.801 0.6780049190062772 0.678003352604235 -1.0485759467382394e-06 -0.08387584326810218 -0.8011 0.6780132112675161 0.6780116656664557 -1.0518992426544749e-06 -0.0838803466868636 -0.8012 0.6780215012792454 0.6780199765435941 -1.0550075129345249e-06 -0.08388484895807424 -0.8013000000000001 0.6780297890441925 0.678028285233937 -1.0579001328558935e-06 -0.08388935008196496 -0.8014000000000001 0.6780380745650911 0.6780365917357642 -1.0605765235760511e-06 -0.08389385005876657 -0.8015 0.6780463578446803 0.6780448960473507 -1.063036152326724e-06 -0.0838983488887099 -0.8016 0.6780546388857042 0.678053198166966 -1.0652785323306269e-06 -0.08390284657202576 -0.8017000000000001 0.6780629176909116 0.6780614980928743 -1.0673032229402413e-06 -0.08390734310894493 -0.8018000000000001 0.6780711942630553 0.6780697958233364 -1.0691098299708823e-06 -0.08391183849969819 -0.8019000000000001 0.6780794686048917 0.6780780913566093 -1.0706980052566095e-06 -0.08391633274451635 -0.802 0.6780877407191805 0.6780863846909464 -1.0720674474551384e-06 -0.08392082584363014 -0.8021 0.6780960106086839 0.678094675824598 -1.0732179013261955e-06 -0.0839253177972703 -0.8022 0.6781042782761664 0.6781029647558132 -1.0741491583421414e-06 -0.08392980860566766 -0.8023 0.6781125437243936 0.6781112514828377 -1.0748610565491923e-06 -0.08393429826905278 -0.8024000000000001 0.6781208069561335 0.6781195360039172 -1.0753534805119092e-06 -0.08393878678765651 -0.8025 0.6781290679741537 0.6781278183172958 -1.0756263613964645e-06 -0.08394327416170946 -0.8026 0.6781373267812227 0.6781360984212176 -1.075679677053909e-06 -0.08394776039144239 -0.8027000000000001 0.6781455833801089 0.6781443763139263 -1.0755134519646603e-06 -0.08395224547708596 -0.8028000000000001 0.6781538377735794 0.6781526519936667 -1.0751277571552365e-06 -0.08395672941887078 -0.8029000000000001 0.6781620899644004 0.6781609254586842 -1.0745227101427446e-06 -0.08396121221702753 -0.803 0.6781703399553363 0.6781691967072262 -1.0736984752957035e-06 -0.08396569387178689 -0.8031 0.67817858774915 0.6781774657375418 -1.0726552631956654e-06 -0.08397017438337946 -0.8032 0.6781868333486009 0.6781857325478824 -1.0713933311090607e-06 -0.08397465375203586 -0.8033 0.6781950767564457 0.6781939971365029 -1.0699129825431086e-06 -0.0839791319779867 -0.8034000000000001 0.6782033179754379 0.678202259501661 -1.068214567412351e-06 -0.08398360906146257 -0.8035 0.6782115570083261 0.6782105196416187 -1.0662984819553856e-06 -0.08398808500269402 -0.8036 0.6782197938578551 0.6782187775546427 -1.0641651683740427e-06 -0.08399255980191166 -0.8037000000000001 0.6782280285267642 0.6782270332390038 -1.0618151152774757e-06 -0.083997033459346 -0.8038000000000001 0.6782362610177877 0.6782352866929787 -1.059248856905004e-06 -0.08400150597522762 -0.8039000000000001 0.6782444913336536 0.6782435379148498 -1.0564669735979582e-06 -0.08400597734978707 -0.804 0.6782527194770835 0.6782517869029057 -1.053470091189057e-06 -0.0840104475832548 -0.8041 0.6782609454507922 0.6782600336554416 -1.0502588811689417e-06 -0.08401491667586135 -0.8042 0.678269169257487 0.6782682781707605 -1.0468340604918858e-06 -0.08401938462783723 -0.8043 0.6782773908998677 0.6782765204471727 -1.0431963913537512e-06 -0.08402385143941289 -0.8044000000000001 0.6782856103806255 0.6782847604829965 -1.039346681136477e-06 -0.08402831711081885 -0.8045 0.6782938277024431 0.6782929982765591 -1.0352857820472572e-06 -0.08403278164228553 -0.8046 0.6783020428679934 0.6783012338261964 -1.0310145909520063e-06 -0.08403724503404338 -0.8047000000000001 0.6783102558799403 0.6783094671302545 -1.0265340492920938e-06 -0.08404170728632279 -0.8048000000000001 0.6783184667409373 0.6783176981870891 -1.021845143112099e-06 -0.08404616839935426 -0.8049000000000001 0.6783266754536272 0.6783259269950661 -1.0169489022548994e-06 -0.08405062837336813 -0.805 0.678334882020642 0.6783341535525629 -1.0118464007780048e-06 -0.08405508720859482 -0.8051 0.6783430864446016 0.6783423778579676 -1.006538755954356e-06 -0.08405954490526468 -0.8052 0.678351288728115 0.6783505999096808 -1.0010271289662143e-06 -0.08406400146360812 -0.8053 0.6783594888737778 0.6783588197061151 -9.9531272385045e-07 -0.0840684568838555 -0.8054000000000001 0.6783676868841736 0.6783670372456954 -9.893967875818088e-07 -0.08407291116623716 -0.8055 0.6783758827618718 0.6783752525268599 -9.832806100451563e-07 -0.08407736431098338 -0.8056 0.6783840765094288 0.678383465548061 -9.769655231750551e-07 -0.08408181631832452 -0.8057000000000001 0.6783922681293868 0.6783916763077644 -9.704529010390317e-07 -0.0840862671884909 -0.8058000000000001 0.678400457624273 0.6783998848044505 -9.637441596432872e-07 -0.08409071692171279 -0.8059000000000001 0.6784086449966 0.6784080910366146 -9.568407562665637e-07 -0.08409516551822051 -0.806 0.6784168302488649 0.678416295002767 -9.497441895434111e-07 -0.08409961297824425 -0.8061 0.6784250133835488 0.6784244967014343 -9.424559987564196e-07 -0.08410405930201433 -0.8062 0.6784331944031166 0.6784326961311586 -9.349777638500978e-07 -0.08410850448976097 -0.8063 0.6784413733100165 0.6784408932904988 -9.273111048618832e-07 -0.08411294854171442 -0.8064000000000001 0.6784495501066796 0.6784490881780311 -9.194576815335642e-07 -0.08411739145810482 -0.8065 0.6784577247955197 0.6784572807923486 -9.114191933112803e-07 -0.0841218332391625 -0.8066 0.6784658973789324 0.6784654711320621 -9.031973784434655e-07 -0.08412627388511754 -0.8067000000000001 0.678474067859295 0.6784736591958012 -8.947940142028932e-07 -0.08413071339620018 -0.8068000000000001 0.6784822362389662 0.6784818449822134 -8.862109159013531e-07 -0.08413515177264055 -0.8069000000000001 0.6784904025202856 0.6784900284899653 -8.774499369590405e-07 -0.08413958901466882 -0.807 0.6784985667055734 0.6784982097177434 -8.68512968293933e-07 -0.08414402512251515 -0.8071 0.6785067287971299 0.6785063886642533 -8.59401938058113e-07 -0.08414846009640965 -0.8072 0.6785148887972346 0.678514565328221 -8.501188109855118e-07 -0.08415289393658237 -0.8073 0.6785230467081473 0.6785227397083926 -8.406655881976199e-07 -0.08415732664326353 -0.8074000000000001 0.6785312025321064 0.6785309118035356 -8.310443066344986e-07 -0.08416175821668312 -0.8075 0.6785393562713287 0.6785390816124386 -8.21257038666201e-07 -0.08416618865707125 -0.8076 0.6785475079280094 0.6785472491339115 -8.113058917735838e-07 -0.08417061796465797 -0.8077000000000001 0.6785556575043219 0.6785554143667865 -8.01193007868295e-07 -0.08417504613967333 -0.8078000000000001 0.6785638050024166 0.6785635773099177 -7.909205629458294e-07 -0.08417947318234738 -0.8079000000000001 0.6785719504244216 0.6785717379621823 -7.80490766613684e-07 -0.08418389909291013 -0.808 0.6785800937724421 0.6785798963224802 -7.699058617305354e-07 -0.08418832387159159 -0.8081 0.678588235048559 0.6785880523897345 -7.591681236707171e-07 -0.08419274751862177 -0.8082 0.6785963742548301 0.6785962061628924 -7.482798599911522e-07 -0.08419717003423062 -0.8083 0.6786045113932888 0.6786043576409246 -7.372434100150205e-07 -0.08420159141864814 -0.8084000000000001 0.6786126464659441 0.6786125068228265 -7.260611441239906e-07 -0.08420601167210423 -0.8085 0.6786207794747801 0.6786206537076178 -7.14735463522298e-07 -0.08421043079482891 -0.8086 0.678628910421756 0.6786287982943435 -7.03268799445711e-07 -0.08421484878705207 -0.8087000000000001 0.6786370393088057 0.6786369405820738 -6.916636127868303e-07 -0.08421926564900363 -0.8088000000000001 0.6786451661378374 0.6786450805699038 -6.799223935816112e-07 -0.08422368138091353 -0.8089000000000001 0.678653290910733 0.6786532182569553 -6.680476603293517e-07 -0.0842280959830116 -0.809 0.6786614136293483 0.6786613536423758 -6.560419597290146e-07 -0.08423250945552771 -0.8091 0.6786695342955124 0.6786694867253391 -6.439078659159492e-07 -0.08423692179869174 -0.8092 0.6786776529110281 0.6786776175050462 -6.316479798512686e-07 -0.08424133301273358 -0.8093 0.6786857694776703 0.6786857459807247 -6.19264928988783e-07 -0.08424574309788302 -0.8094000000000001 0.6786938839971873 0.6786938721516296 -6.067613665533544e-07 -0.08425015205436992 -0.8095 0.6787019964712993 0.6787019960170431 -5.941399710829298e-07 -0.08425455988242406 -0.8096 0.6787101069016988 0.6787101175762755 -5.81403445720774e-07 -0.08425896658227527 -0.8097000000000001 0.6787182152900497 0.6787182368286648 -5.68554517785258e-07 -0.08426337215415326 -0.8098000000000001 0.6787263216379883 0.6787263537735775 -5.555959380204589e-07 -0.08426777659828787 -0.8099000000000001 0.6787344259471213 0.6787344684104086 -5.425304802214592e-07 -0.08427217991490879 -0.81 0.6787425282190274 0.6787425807385816 -5.293609403739241e-07 -0.0842765821042458 -0.8101 0.678750628455256 0.6787506907575493 -5.160901363765458e-07 -0.08428098316652863 -0.8102 0.678758726657327 0.6787587984667934 -5.027209071389871e-07 -0.08428538310198701 -0.8103 0.6787668228267307 0.678766903865825 -4.892561121586092e-07 -0.08428978191085063 -0.8104000000000001 0.6787749169649278 0.6787750069541846 -4.7569863082658204e-07 -0.08429417959334912 -0.8105 0.6787830090733491 0.6787831077314431 -4.620513618311395e-07 -0.08429857614971224 -0.8106 0.6787910991533953 0.6787912061972006 -4.48317222595529e-07 -0.08430297158016957 -0.8107000000000001 0.6787991872064368 0.6787993023510879 -4.34499148591061e-07 -0.08430736588495076 -0.8108000000000001 0.6788072732338136 0.6788073961927664 -4.2060009273342525e-07 -0.08431175906428555 -0.8109000000000001 0.678815357236835 0.6788154877219273 -4.066230246818625e-07 -0.08431615111840347 -0.811 0.678823439216779 0.6788235769382929 -3.9257093035344193e-07 -0.08432054204753414 -0.8111 0.6788315191748931 0.6788316638416163 -3.7844681116672163e-07 -0.08432493185190715 -0.8112 0.6788395971123937 0.6788397484316815 -3.6425368346582054e-07 -0.08432932053175209 -0.8113 0.6788476730304656 0.6788478307083039 -3.499945777848956e-07 -0.08433370808729851 -0.8114000000000001 0.6788557469302621 0.67885591067133 -3.3567253830690813e-07 -0.08433809451877594 -0.8115 0.6788638188129053 0.6788639883206378 -3.2129062219055093e-07 -0.08434247982641392 -0.8116 0.6788718886794853 0.678872063656137 -3.0685189883472574e-07 -0.08434686401044203 -0.8117000000000001 0.6788799565310605 0.6788801366777688 -2.9235944937200387e-07 -0.08435124707108971 -0.8118000000000001 0.6788880223686572 0.6788882073855063 -2.778163658498367e-07 -0.08435562900858647 -0.8119000000000001 0.67889608619327 0.6788962757793546 -2.6322575071013876e-07 -0.08436000982316183 -0.812 0.678904148005861 0.6789043418593507 -2.485907160433565e-07 -0.08436438951504523 -0.8121 0.6789122078073602 0.6789124056255635 -2.3391438294315114e-07 -0.08436876808446614 -0.8122 0.6789202655986648 0.6789204670780944 -2.191998808333262e-07 -0.08437314553165391 -0.8123 0.6789283213806404 0.6789285262170768 -2.044503468398573e-07 -0.08437752185683801 -0.8124000000000001 0.6789363751541196 0.6789365830426769 -1.8966892507965571e-07 -0.0843818970602479 -0.8125 0.6789444269199026 0.6789446375550932 -1.7485876602912898e-07 -0.08438627114211293 -0.8126 0.6789524766787571 0.6789526897545561 -1.600230258164137e-07 -0.0843906441026625 -0.8127000000000001 0.6789605244314179 0.6789607396413293 -1.4516486555350705e-07 -0.084395015942126 -0.8128000000000001 0.6789685701785866 0.6789687872157086 -1.3028745068748016e-07 -0.08439938666073273 -0.8129000000000001 0.6789766139209332 0.6789768324780228 -1.15393950304854e-07 -0.08440375625871206 -0.813 0.678984655659094 0.6789848754286327 -1.004875364654656e-07 -0.08440812473629328 -0.8131 0.6789926953936729 0.6789929160679324 -8.557138352245641e-08 -0.08441249209370574 -0.8132 0.6790007331252408 0.6790009543963487 -7.064866745266907e-08 -0.08441685833117873 -0.8133 0.6790087688543356 0.6790089904143404 -5.572256517099791e-08 -0.08442122344894148 -0.8134000000000001 0.6790168025814628 0.6790170241223998 -4.079625385796683e-08 -0.08442558744722332 -0.8135 0.6790248343070947 0.6790250555210517 -2.587291028849966e-08 -0.08442995032625351 -0.8136 0.679032864031671 0.6790330846108533 -1.0955710148547598e-08 -0.08443431208626126 -0.8137000000000001 0.6790408917555983 0.6790411113923949 3.952172636899343e-09 -0.08443867272747584 -0.8138000000000001 0.6790489174792508 0.6790491358662991 1.884756658035447e-08 -0.08444303225012642 -0.8139000000000001 0.6790569412029691 0.6790571580332211 3.3727303307834466e-08 -0.08444739065444216 -0.814 0.6790649629270621 0.6790651778938491 4.858821823702786e-08 -0.0844517479406523 -0.8141 0.6790729826518054 0.6790731954489037 6.342715123779097e-08 -0.084456104108986 -0.8142 0.6790810003774421 0.6790812106991375 7.824094732343523e-08 -0.08446045915967239 -0.8143 0.6790890161041827 0.6790892236453361 9.302645730471792e-08 -0.08446481309294061 -0.8144000000000001 0.6790970298322053 0.6790972342883177 1.0778053844903712e-07 -0.08446916590901982 -0.8145 0.6791050415616556 0.6791052426289319 1.2250005520381135e-07 -0.0844735176081391 -0.8146 0.6791130512926467 0.6791132486680611 1.3718187980016339e-07 -0.08447786819052755 -0.8147000000000001 0.6791210590252597 0.6791212524066201 1.5182289294854434e-07 -0.08448221765641428 -0.8148000000000001 0.6791290647595428 0.6791292538455551 1.664199845048675e-07 -0.08448656600602829 -0.8149000000000001 0.6791370684955133 0.6791372529858446 1.8097005409847822e-07 -0.08449091323959868 -0.815 0.6791450702331555 0.6791452498284989 1.9547001184339052e-07 -0.08449525935735447 -0.8151 0.6791530699724229 0.67915324437456 2.0991677897319594e-07 -0.08449960435952475 -0.8152 0.6791610677132358 0.6791612366251016 2.2430728845862502e-07 -0.08450394824633843 -0.8153 0.6791690634554841 0.6791692265812286 2.3863848572919233e-07 -0.08450829101802454 -0.8154000000000001 0.6791770571990255 0.6791772142440775 2.5290732926647186e-07 -0.08451263267481206 -0.8155 0.6791850489436873 0.6791851996148159 2.6711079125635306e-07 -0.08451697321692997 -0.8156 0.6791930386892644 0.6791931826946427 2.8124585826211357e-07 -0.08452131264460722 -0.8157000000000001 0.6792010264355214 0.6792011634847872 2.9530953182810293e-07 -0.08452565095807274 -0.8158000000000001 0.6792090121821915 0.6792091419865098 3.0929882918750984e-07 -0.08452998815755541 -0.8159000000000001 0.6792169959289778 0.6792171182011015 3.232107837966569e-07 -0.08453432424328416 -0.816 0.6792249776755527 0.6792250921298835 3.3704244600113453e-07 -0.08453865921548792 -0.8161 0.6792329574215579 0.6792330637742074 3.507908836741791e-07 -0.08454299307439551 -0.8162 0.6792409351666049 0.6792410331354546 3.644531829036235e-07 -0.08454732582023579 -0.8163 0.6792489109102758 0.6792490002150369 3.780264484706808e-07 -0.08455165745323767 -0.8164000000000001 0.6792568846521223 0.6792569650143951 3.915078045785281e-07 -0.08455598797362993 -0.8165 0.679264856391667 0.679264927535 4.048943953866013e-07 -0.08456031738164142 -0.8166 0.6792728261284025 0.6792728877783509 4.1818338571142366e-07 -0.08456464567750088 -0.8167000000000001 0.679280793861793 0.6792808457459768 4.3137196151232793e-07 -0.08456897286143716 -0.8168000000000001 0.6792887595912731 0.6792888014394354 4.4445733060616277e-07 -0.08457329893367901 -0.8169000000000001 0.679296723316249 0.6792967548603126 4.574367231807708e-07 -0.0845776238944552 -0.817 0.6793046850360985 0.6793047060102229 4.7030739230846663e-07 -0.08458194774399443 -0.8171 0.6793126447501714 0.6793126548908088 4.830666147231932e-07 -0.08458627048252554 -0.8172 0.6793206024577887 0.679320601503741 4.957116912646109e-07 -0.08459059211027713 -0.8173 0.6793285581582443 0.679328545850717 5.08239947558109e-07 -0.08459491262747788 -0.8174000000000001 0.6793365118508046 0.6793364879334621 5.206487343617505e-07 -0.08459923203435654 -0.8175 0.6793444635347088 0.6793444277537288 5.329354283434284e-07 -0.08460355033114175 -0.8176 0.6793524132091688 0.6793523653132961 5.450974326082214e-07 -0.08460786751806215 -0.8177000000000001 0.6793603608733705 0.6793603006139698 5.571321770869719e-07 -0.08461218359534645 -0.8178000000000001 0.6793683065264731 0.6793682336575815 5.69037119341198e-07 -0.08461649856322317 -0.8179000000000001 0.679376250167609 0.679376164445989 5.808097448545269e-07 -0.08462081242192093 -0.818 0.6793841917958863 0.6793840929810762 5.924475677265839e-07 -0.08462512517166841 -0.8181 0.6793921314103861 0.6793920192647516 6.039481311587158e-07 -0.08462943681269411 -0.8182 0.6794000690101657 0.6793999432989486 6.153090078286905e-07 -0.08463374734522658 -0.8183 0.6794080045942565 0.6794078650856263 6.265278006539754e-07 -0.08463805676949444 -0.8184000000000001 0.6794159381616656 0.6794157846267679 6.37602143166438e-07 -0.08464236508572616 -0.8185 0.6794238697113757 0.6794237019243798 6.485296999980683e-07 -0.08464667229415024 -0.8186 0.6794317992423464 0.6794316169804933 6.593081674638457e-07 -0.08465097839499523 -0.8187000000000001 0.6794397267535128 0.6794395297971623 6.699352738531728e-07 -0.08465528338848956 -0.8188000000000001 0.6794476522437876 0.6794474403764648 6.804087801515202e-07 -0.08465958727486178 -0.8189000000000001 0.6794555757120592 0.6794553487205004 6.907264804567603e-07 -0.08466389005434029 -0.819 0.679463497157195 0.6794632548313919 7.008862022012119e-07 -0.08466819172715352 -0.8191 0.6794714165780391 0.6794711587112843 7.108858070398183e-07 -0.08467249229352991 -0.8192 0.6794793339734144 0.6794790603623435 7.207231908779033e-07 -0.08467679175369787 -0.8193 0.679487249342122 0.6794869597867574 7.30396284578938e-07 -0.08468109010788581 -0.8194000000000001 0.679495162682942 0.6794948569867348 7.39903054311486e-07 -0.08468538735632208 -0.8195 0.6795030739946334 0.679502751964505 7.492415019794141e-07 -0.08468968349923504 -0.8196 0.6795109832759352 0.6795106447223178 7.584096657908823e-07 -0.08469397853685307 -0.8197000000000001 0.6795188905255661 0.6795185352624423 7.674056203693658e-07 -0.08469827246940444 -0.8198000000000001 0.6795267957422253 0.679526423587168 7.762274774059108e-07 -0.08470256529711753 -0.8199000000000001 0.6795346989245927 0.6795343096988027 7.848733859366908e-07 -0.08470685702022063 -0.82 0.6795426000713295 0.679542193599673 7.933415328148508e-07 -0.08471114763894196 -0.8201 0.6795504991810782 0.6795500752921244 8.01630143015819e-07 -0.08471543715350985 -0.8202 0.6795583962524634 0.67955795477852 8.097374801646628e-07 -0.08471972556415255 -0.8203 0.6795662912840917 0.6795658320612403 8.176618466193553e-07 -0.08472401287109832 -0.8204000000000001 0.6795741842745529 0.6795737071426831 8.254015841091533e-07 -0.08472829907457528 -0.8205 0.6795820752224196 0.6795815800252625 8.329550739566427e-07 -0.08473258417481173 -0.8206 0.6795899641262482 0.67958945071141 8.403207374108046e-07 -0.08473686817203585 -0.8207000000000001 0.6795978509845786 0.6795973192035716 8.474970359662048e-07 -0.08474115106647583 -0.8208000000000001 0.6796057357959356 0.6796051855042099 8.544824717654498e-07 -0.08474543285835975 -0.8209000000000001 0.6796136185588287 0.6796130496158017 8.612755878351086e-07 -0.08474971354791583 -0.821 0.6796214992717525 0.6796209115408389 8.678749684881693e-07 -0.08475399313537216 -0.8211 0.6796293779331872 0.6796287712818275 8.742792394905718e-07 -0.08475827162095684 -0.8212 0.6796372545415995 0.6796366288412875 8.80487068435909e-07 -0.08476254900489806 -0.8213 0.6796451290954417 0.6796444842217519 8.864971650091036e-07 -0.08476682528742376 -0.8214000000000001 0.6796530015931542 0.6796523374257666 8.923082812639649e-07 -0.08477110046876213 -0.8215 0.6796608720331638 0.6796601884558902 8.979192118452328e-07 -0.08477537454914111 -0.8216 0.6796687404138861 0.6796680373146933 9.033287942106227e-07 -0.08477964752878882 -0.8217000000000001 0.6796766067337243 0.6796758840047575 9.085359090610368e-07 -0.08478391940793324 -0.8218000000000001 0.6796844709910705 0.6796837285286763 9.135394803405639e-07 -0.08478819018680239 -0.8219000000000001 0.6796923331843063 0.6796915708890537 9.183384755695467e-07 -0.08479245986562427 -0.822 0.6797001933118023 0.6796994110885033 9.229319061498931e-07 -0.08479672844462677 -0.8221 0.6797080513719194 0.6797072491296494 9.273188273095645e-07 -0.08480099592403789 -0.8222 0.6797159073630098 0.6797150850151248 9.314983385466657e-07 -0.08480526230408564 -0.8223 0.6797237612834157 0.6797229187475715 9.354695838514893e-07 -0.08480952758499782 -0.8224000000000001 0.6797316131314712 0.6797307503296404 9.392317514844706e-07 -0.08481379176700246 -0.8225 0.6797394629055022 0.6797385797639892 9.427840747255889e-07 -0.08481805485032734 -0.8226 0.6797473106038268 0.6797464070532842 9.461258315413001e-07 -0.08482231683520036 -0.8227000000000001 0.6797551562247568 0.6797542322001979 9.492563448898483e-07 -0.08482657772184943 -0.8228000000000001 0.6797629997665962 0.6797620552074095 9.52174983082088e-07 -0.0848308375105023 -0.8229000000000001 0.6797708412276439 0.6797698760776048 9.548811595039286e-07 -0.0848350962013869 -0.823 0.6797786806061918 0.6797776948134744 9.573743330326678e-07 -0.08483935379473094 -0.8231 0.6797865179005276 0.6797855114177147 9.596540081480143e-07 -0.08484361029076226 -0.8232 0.6797943531089335 0.6797933258930264 9.617197349875983e-07 -0.08484786568970865 -0.8233 0.6798021862296882 0.6798011382421149 9.635711090971721e-07 -0.08485211999179788 -0.8234000000000001 0.6798100172610656 0.6798089484676886 9.652077721522545e-07 -0.0848563731972577 -0.8235 0.6798178462013367 0.6798167565724592 9.666294115417973e-07 -0.0848606253063158 -0.8236 0.6798256730487693 0.6798245625591419 9.678357605347188e-07 -0.08486487631919992 -0.8237000000000001 0.6798334978016289 0.6798323664304533 9.688265984741928e-07 -0.08486912623613768 -0.8238000000000001 0.6798413204581797 0.6798401681891124 9.69601750638871e-07 -0.08487337505735687 -0.8239000000000001 0.6798491410166834 0.6798479678378393 9.701610883816603e-07 -0.08487762278308508 -0.824 0.6798569594754009 0.6798557653793553 9.705045291574788e-07 -0.08488186941355003 -0.8241 0.679864775832593 0.6798635608163817 9.706320365232557e-07 -0.08488611494897925 -0.8242 0.6798725900865201 0.6798713541516399 9.70543619971398e-07 -0.08489035938960043 -0.8243 0.6798804022354433 0.6798791453878507 9.70239335318368e-07 -0.0848946027356412 -0.8244000000000001 0.6798882122776244 0.6798869345277336 9.697192841495728e-07 -0.08489884498732907 -0.8245 0.6798960202113262 0.6798947215740072 9.68983614207941e-07 -0.08490308614489157 -0.8246 0.6799038260348144 0.6799025065293876 9.680325193661687e-07 -0.08490732620855641 -0.8247000000000001 0.6799116297463557 0.6799102893965883 9.668662391826288e-07 -0.08491156517855097 -0.8248000000000001 0.6799194313442206 0.6799180701783206 9.654850592621944e-07 -0.08491580305510282 -0.8249000000000001 0.6799272308266822 0.6799258488772917 9.638893111174607e-07 -0.08492003983843943 -0.825 0.6799350281920176 0.6799336254962051 9.620793717524112e-07 -0.08492427552878827 -0.8251000000000001 0.6799428234385085 0.6799414000377602 9.600556640232405e-07 -0.08492851012637688 -0.8252 0.6799506165644411 0.6799491725046514 9.578186564163094e-07 -0.08493274363143272 -0.8253 0.6799584075681063 0.6799569428995675 9.553688626595669e-07 -0.08493697604418318 -0.8254000000000001 0.6799661964478008 0.6799647112251922 9.527068419168394e-07 -0.08494120736485566 -0.8255 0.6799739832018277 0.679972477484202 9.498331985102748e-07 -0.08494543759367755 -0.8256 0.6799817678284963 0.679980241679268 9.467485819480981e-07 -0.0849496667308763 -0.8257000000000001 0.6799895503261232 0.6799880038130528 9.434536867303223e-07 -0.08495389477667925 -0.8258000000000001 0.6799973306930323 0.6799957638882124 9.399492518769037e-07 -0.08495812173131373 -0.8259000000000001 0.6800051089275556 0.6800035219073943 9.362360613440757e-07 -0.08496234759500715 -0.826 0.680012885028033 0.680011277873237 9.323149433304589e-07 -0.08496657236798667 -0.8261000000000001 0.6800206589928143 0.680019031788371 9.28186770332573e-07 -0.08497079605047977 -0.8262 0.6800284308202575 0.6800267836554164 9.238524590060582e-07 -0.08497501864271363 -0.8263 0.680036200508731 0.680034533476984 9.193129697215863e-07 -0.08497924014491552 -0.8264000000000001 0.6800439680566133 0.6800422812556737 9.145693066758831e-07 -0.08498346055731272 -0.8265 0.6800517334622935 0.680050026994075 9.09622517392128e-07 -0.08498767988013248 -0.8266 0.6800594967241721 0.6800577706947661 9.044736927477093e-07 -0.08499189811360197 -0.8267 0.6800672578406608 0.6800655123603137 8.991239663913575e-07 -0.08499611525794845 -0.8268000000000001 0.6800750168101832 0.6800732519932713 8.935745147709007e-07 -0.08500033131339904 -0.8269000000000001 0.6800827736311759 0.6800809895961812 8.878265569944865e-07 -0.08500454628018095 -0.827 0.6800905283020877 0.6800887251715719 8.818813541089376e-07 -0.08500876015852131 -0.8271000000000001 0.6800982808213815 0.6800964587219585 8.757402091552624e-07 -0.08501297294864726 -0.8272 0.6801060311875333 0.6801041902498424 8.69404466918855e-07 -0.08501718465078593 -0.8273 0.6801137793990335 0.6801119197577106 8.628755134715282e-07 -0.08502139526516443 -0.8274000000000001 0.6801215254543871 0.6801196472480349 8.561547759078358e-07 -0.08502560479200977 -0.8275 0.6801292693521144 0.6801273727232725 8.492437221507831e-07 -0.08502981323154907 -0.8276 0.6801370110907505 0.6801350961858654 8.421438604661047e-07 -0.08503402058400941 -0.8277 0.6801447506688469 0.6801428176382385 8.348567392402195e-07 -0.08503822684961776 -0.8278000000000001 0.6801524880849712 0.6801505370828009 8.273839466471644e-07 -0.08504243202860115 -0.8279000000000001 0.6801602233377075 0.680158254521945 8.197271102461379e-07 -0.0850466361211866 -0.828 0.6801679564256574 0.6801659699580457 8.118878966623111e-07 -0.08505083912760106 -0.8281000000000001 0.6801756873474397 0.6801736833934604 8.038680112398833e-07 -0.08505504104807154 -0.8282 0.6801834161016911 0.6801813948305284 7.956691976118702e-07 -0.08505924188282493 -0.8283 0.6801911426870664 0.6801891042715709 7.872932374225483e-07 -0.08506344163208822 -0.8284000000000001 0.6801988671022393 0.6801968117188897 7.787419498556103e-07 -0.08506764029608829 -0.8285 0.6802065893459025 0.6802045171747679 7.700171912594644e-07 -0.08507183787505201 -0.8286 0.6802143094167683 0.6802122206414689 7.61120854744779e-07 -0.0850760343692063 -0.8287 0.6802220273135686 0.6802199221212359 7.520548699208041e-07 -0.08508022977877802 -0.8288000000000001 0.6802297430350555 0.6802276216162921 7.42821202159849e-07 -0.085084424103994 -0.8289000000000001 0.6802374565800013 0.6802353191288403 7.334218524446268e-07 -0.08508861734508111 -0.829 0.6802451679472 0.6802430146610614 7.23858856882531e-07 -0.08509280950226611 -0.8291000000000001 0.6802528771354661 0.6802507082151152 7.141342861782807e-07 -0.0850970005757758 -0.8292 0.6802605841436364 0.6802583997931404 7.042502453008526e-07 -0.08510119056583698 -0.8293 0.680268288970569 0.6802660893972526 6.942088728589813e-07 -0.08510537947267638 -0.8294000000000001 0.6802759916151448 0.6802737770295455 6.840123408652365e-07 -0.08510956729652074 -0.8295 0.6802836920762672 0.68028146269209 6.736628541254008e-07 -0.0851137540375968 -0.8296 0.6802913903528623 0.6802891463869336 6.631626497805021e-07 -0.08511793969613131 -0.8297 0.6802990864438802 0.6802968281161006 6.525139968072136e-07 -0.08512212427235089 -0.8298000000000001 0.6803067803482941 0.6803045078815912 6.417191956431534e-07 -0.08512630776648221 -0.8299000000000001 0.6803144720651011 0.6803121856853818 6.307805775346287e-07 -0.08513049017875195 -0.83 0.680322161593323 0.680319861529424 6.197005041203019e-07 -0.08513467150938672 -0.8301000000000001 0.680329848932006 0.6803275354156451 6.084813669038347e-07 -0.08513885175861316 -0.8302 0.6803375340802214 0.6803352073459472 5.971255867404102e-07 -0.08514303092665793 -0.8303 0.6803452170370654 0.6803428773222069 5.856356133510099e-07 -0.0851472090137475 -0.8304000000000001 0.6803528978016596 0.6803505453462754 5.740139247256693e-07 -0.08515138602010858 -0.8305 0.6803605763731518 0.6803582114199775 5.622630266516326e-07 -0.08515556194596759 -0.8306 0.6803682527507156 0.6803658755451124 5.503854521443641e-07 -0.08515973679155112 -0.8307 0.680375926933551 0.6803735377234523 5.383837609201914e-07 -0.08516391055708566 -0.8308000000000001 0.6803835989208844 0.6803811979567432 5.262605388550723e-07 -0.08516808324279772 -0.8309000000000001 0.6803912687119696 0.6803888562467035 5.140183973045831e-07 -0.0851722548489138 -0.831 0.680398936306087 0.6803965125950246 5.016599726875848e-07 -0.08517642537566034 -0.8311000000000001 0.6804066017025447 0.6804041670033706 4.891879259588672e-07 -0.0851805948232638 -0.8312 0.6804142649006784 0.6804118194733773 4.7660494185974844e-07 -0.0851847631919506 -0.8313 0.6804219258998514 0.6804194700066526 4.639137285017414e-07 -0.08518893048194714 -0.8314000000000001 0.6804295846994556 0.6804271186047762 4.511170166865419e-07 -0.0851930966934798 -0.8315 0.680437241298911 0.6804347652692996 4.3821755936479523e-07 -0.085197261826775 -0.8316 0.6804448956976661 0.6804424100017452 4.2521813102547323e-07 -0.08520142588205909 -0.8317 0.6804525478951984 0.6804500528036066 4.1212152708525185e-07 -0.08520558885955837 -0.8318000000000001 0.6804601978910142 0.6804576936763482 3.989305633472773e-07 -0.08520975075949921 -0.8319000000000001 0.6804678456846488 0.6804653326214054 3.8564807530727663e-07 -0.08521391158210787 -0.832 0.6804754912756676 0.6804729696401832 3.72276917688652e-07 -0.08521807132761063 -0.8321000000000001 0.6804831346636651 0.6804806047340577 3.5881996361675217e-07 -0.08522222999623381 -0.8322 0.6804907758482655 0.6804882379043746 3.4528010422335553e-07 -0.08522638758820361 -0.8323 0.6804984148291233 0.68049586915245 3.3166024789033077e-07 -0.0852305441037463 -0.8324000000000001 0.6805060516059228 0.6805034984795686 3.179633196598308e-07 -0.08523469954308802 -0.8325 0.6805136861783792 0.6805111258869859 3.0419226058203686e-07 -0.08523885390645504 -0.8326 0.6805213185462374 0.6805187513759263 2.903500271322912e-07 -0.08524300719407354 -0.8327 0.6805289487092736 0.6805263749475834 2.7643959056578016e-07 -0.0852471594061697 -0.8328000000000001 0.6805365766672943 0.6805339966031198 2.624639362583392e-07 -0.0852513105429696 -0.8329000000000001 0.6805442024201371 0.6805416163436669 2.4842606308195236e-07 -0.08525546060469939 -0.833 0.6805518259676708 0.6805492341703254 2.343289827178019e-07 -0.08525960959158523 -0.8331000000000001 0.6805594473097949 0.6805568500841643 2.2017571910809552e-07 -0.08526375750385311 -0.8332 0.6805670664464405 0.6805644640862213 2.0596930774136046e-07 -0.08526790434172916 -0.8333 0.6805746833775707 0.6805720761775025 1.9171279496549287e-07 -0.08527205010543946 -0.8334000000000001 0.6805822981031788 0.6805796863589822 1.774092373979519e-07 -0.08527619479521002 -0.8335 0.6805899106232908 0.6805872946316033 1.630617012804425e-07 -0.08528033841126682 -0.8336 0.680597520937964 0.6805949009962764 1.4867326173992335e-07 -0.08528448095383591 -0.8337 0.6806051290472878 0.6806025054538807 1.3424700223002572e-07 -0.08528862242314328 -0.8338000000000001 0.6806127349513827 0.6806101080052624 1.1978601381287812e-07 -0.08529276281941482 -0.8339000000000001 0.6806203386504022 0.6806177086512368 1.0529339448603348e-07 -0.08529690214287655 -0.834 0.6806279401445311 0.6806253073925864 9.077224854756039e-08 -0.08530104039375438 -0.8341000000000001 0.6806355394339862 0.6806329042300614 7.622568595072599e-08 -0.08530517757227418 -0.8342 0.6806431365190172 0.68064049916438 6.165682155979957e-08 -0.08530931367866189 -0.8343 0.6806507313999053 0.6806480921962279 4.7068774574124395e-08 -0.08531344871314336 -0.8344000000000001 0.6806583240769642 0.6806556833262584 3.246466781514634e-08 -0.08531758267594447 -0.8345 0.6806659145505396 0.6806632725550926 1.7847627051606474e-08 -0.08532171556729101 -0.8346 0.68067350282101 0.6806708598833191 3.2207803438155658e-09 -0.08532584738740889 -0.8347 0.6806810888887855 0.6806784453114939 -1.1412742619877625e-08 -0.08532997813652382 -0.8348000000000001 0.6806886727543089 0.680686028840141 -2.604981120309796e-08 -0.08533410781486166 -0.8349000000000001 0.6806962544180553 0.6806936104697509 -4.068729449213139e-08 -0.08533823642264805 -0.835 0.680703833880532 0.6807011902007829 -5.532206196379348e-08 -0.08534236396010884 -0.8351000000000001 0.680711411142279 0.6807087680336633 -6.9950984149178e-08 -0.08534649042746978 -0.8352 0.6807189862038676 0.6807163439687858 -8.457093331019905e-08 -0.08535061582495651 -0.8353 0.6807265590659026 0.680723918006512 -9.917878410897751e-08 -0.08535474015279475 -0.8354000000000001 0.6807341297290199 0.6807314901471708 -1.1377141427050541e-07 -0.08535886341121014 -0.8355 0.6807416981938885 0.6807390603910595 -1.2834570524249134e-07 -0.0853629856004284 -0.8356 0.6807492644612091 0.6807466287384423 -1.4289854289618875e-07 -0.08536710672067513 -0.8357 0.6807568285317143 0.680754195189551 -1.5742681815957005e-07 -0.08537122677217593 -0.8358000000000001 0.6807643904061692 0.6807617597445864 -1.7192742768346037e-07 -0.08537534575515643 -0.8359000000000001 0.6807719500853705 0.6807693224037159 -1.863972745215492e-07 -0.08537946366984218 -0.836 0.6807795075701472 0.6807768831670756 -2.0083326876876861e-07 -0.08538358051645878 -0.8361000000000001 0.6807870628613595 0.6807844420347693 -2.1523232826906047e-07 -0.08538769629523173 -0.8362 0.6807946159599001 0.6807919990068689 -2.2959137918956984e-07 -0.0853918110063866 -0.8363 0.6808021668666928 0.6807995540834151 -2.439073567908623e-07 -0.08539592465014886 -0.8364000000000001 0.6808097155826933 0.6808071072644162 -2.5817720597162697e-07 -0.08540003722674405 -0.8365 0.6808172621088882 0.680814658549849 -2.7239788199032167e-07 -0.0854041487363976 -0.8366 0.6808248064462961 0.6808222079396592 -2.8656635109314266e-07 -0.08540825917933498 -0.8367 0.6808323485959662 0.6808297554337608 -3.006795911558724e-07 -0.08541236855578159 -0.8368000000000001 0.6808398885589794 0.6808373010320369 -3.147345923465439e-07 -0.08541647686596292 -0.8369000000000001 0.6808474263364469 0.6808448447343389 -3.2872835774994114e-07 -0.08542058411010428 -0.837 0.6808549619295114 0.6808523865404881 -3.4265790400250795e-07 -0.0854246902884311 -0.8371000000000001 0.6808624953393456 0.6808599264502742 -3.565202619862373e-07 -0.08542879540116873 -0.8372 0.680870026567153 0.6808674644634565 -3.7031247734214956e-07 -0.08543289944854249 -0.8373 0.6808775556141677 0.6808750005797639 -3.8403161126132623e-07 -0.08543700243077772 -0.8374000000000001 0.6808850824816537 0.6808825347988952 -3.976747410053272e-07 -0.08544110434809976 -0.8375 0.680892607170905 0.6808900671205182 -4.112389605168132e-07 -0.08544520520073379 -0.8376 0.6809001296832458 0.6808975975442719 -4.247213810856798e-07 -0.08544930498890521 -0.8377 0.6809076500200293 0.6809051260697643 -4.381191319804967e-07 -0.08545340371283915 -0.8378000000000001 0.6809151681826389 0.6809126526965744 -4.514293610036191e-07 -0.0854575013727609 -0.8379000000000001 0.6809226841724868 0.6809201774242519 -4.646492351711995e-07 -0.08546159796889567 -0.838 0.6809301979910144 0.6809277002523171 -4.777759412336047e-07 -0.08546569350146865 -0.8381000000000001 0.6809377096396919 0.6809352211802611 -4.90806686306855e-07 -0.08546978797070498 -0.8382000000000001 0.6809452191200184 0.6809427402075464 -5.037386985318193e-07 -0.08547388137682985 -0.8383 0.6809527264335211 0.6809502573336073 -5.165692275599376e-07 -0.08547797372006839 -0.8384000000000001 0.6809602315817553 0.6809577725578488 -5.292955452401715e-07 -0.08548206500064572 -0.8385 0.6809677345663049 0.6809652858796489 -5.419149461394213e-07 -0.0854861552187869 -0.8386 0.6809752353887808 0.6809727972983568 -5.544247480560038e-07 -0.08549024437471703 -0.8387 0.6809827340508217 0.6809803068132947 -5.668222927829314e-07 -0.08549433246866117 -0.8388000000000001 0.6809902305540932 0.6809878144237573 -5.791049464548559e-07 -0.08549841950084436 -0.8389000000000001 0.6809977249002888 0.680995320129012 -5.91270100269714e-07 -0.08550250547149163 -0.839 0.6810052170911274 0.6810028239282996 -6.0331517097445e-07 -0.08550659038082799 -0.8391000000000001 0.6810127071283555 0.6810103258208342 -6.152376014201266e-07 -0.08551067422907843 -0.8392000000000001 0.6810201950137449 0.6810178258058034 -6.270348610615262e-07 -0.0855147570164679 -0.8393 0.6810276807490935 0.681025323882369 -6.387044466649172e-07 -0.08551883874322132 -0.8394000000000001 0.6810351643362251 0.6810328200496671 -6.502438826133661e-07 -0.08552291940956365 -0.8395 0.6810426457769888 0.6810403143068084 -6.616507215451151e-07 -0.0855269990157198 -0.8396 0.6810501250732582 0.6810478066528782 -6.729225449503273e-07 -0.08553107756191466 -0.8397 0.681057602226932 0.681055297086937 -6.840569634763982e-07 -0.08553515504837311 -0.8398000000000001 0.6810650772399331 0.6810627856080207 -6.950516176912336e-07 -0.08553923147531994 -0.8399000000000001 0.6810725501142088 0.6810702722151414 -7.059041784440723e-07 -0.08554330684298002 -0.84 0.6810800208517298 0.6810777569072868 -7.166123472818198e-07 -0.08554738115157819 -0.8401000000000001 0.6810874894544905 0.681085239683421 -7.271738570457931e-07 -0.08555145440133922 -0.8402000000000001 0.6810949559245081 0.6810927205424855 -7.3758647244071e-07 -0.08555552659248788 -0.8403 0.6811024202638227 0.681100199483398 -7.47847990298367e-07 -0.08555959772524889 -0.8404 0.6811098824744972 0.6811076765050545 -7.579562401466289e-07 -0.08556366779984709 -0.8405 0.6811173425586163 0.6811151516063279 -7.679090847784176e-07 -0.08556773681650712 -0.8406 0.6811248005182862 0.6811226247860696 -7.777044205292682e-07 -0.08557180477545367 -0.8407 0.6811322563556351 0.6811300960431095 -7.873401777630518e-07 -0.08557587167691148 -0.8408000000000001 0.6811397100728117 0.6811375653762561 -7.96814321371575e-07 -0.08557993752110515 -0.8409000000000001 0.6811471616719857 0.6811450327842974 -8.061248512325481e-07 -0.08558400230825935 -0.841 0.681154611155347 0.6811524982660006 -8.152698025148952e-07 -0.0855880660385987 -0.8411000000000001 0.6811620585251056 0.6811599618201127 -8.242472461506001e-07 -0.0855921287123478 -0.8412000000000001 0.6811695037834906 0.6811674234453614 -8.330552892926724e-07 -0.0855961903297312 -0.8413 0.681176946932751 0.6811748831404549 -8.416920756759705e-07 -0.08560025089097348 -0.8414 0.6811843879751541 0.681182340904082 -8.501557860474129e-07 -0.08560431039629918 -0.8415 0.681191826912986 0.6811897967349139 -8.584446383602673e-07 -0.08560836884593287 -0.8416 0.6811992637485502 0.6811972506316026 -8.665568883986507e-07 -0.08561242624009902 -0.8417 0.6812066984841691 0.6812047025927828 -8.744908300967191e-07 -0.08561648257902213 -0.8418000000000001 0.681214131122181 0.6812121526170716 -8.822447958023449e-07 -0.08562053786292667 -0.8419000000000001 0.6812215616649415 0.6812196007030691 -8.898171567212065e-07 -0.08562459209203704 -0.842 0.6812289901148232 0.6812270468493591 -8.972063230694438e-07 -0.08562864526657771 -0.8421000000000001 0.681236416474214 0.6812344910545092 -9.044107447120364e-07 -0.0856326973867731 -0.8422000000000001 0.6812438407455177 0.681241933317071 -9.114289113154594e-07 -0.08563674845284759 -0.8423 0.6812512629311531 0.6812493736355804 -9.182593526807503e-07 -0.08564079846502551 -0.8424 0.6812586830335547 0.6812568120085589 -9.249006390071868e-07 -0.08564484742353126 -0.8425 0.6812661010551702 0.6812642484345135 -9.313513812808649e-07 -0.08564889532858916 -0.8426 0.6812735169984618 0.6812716829119366 -9.376102315383772e-07 -0.08565294218042349 -0.8427 0.6812809308659052 0.6812791154393077 -9.436758831027348e-07 -0.0856569879792586 -0.8428000000000001 0.6812883426599892 0.6812865460150923 -9.495470710135789e-07 -0.08566103272531869 -0.8429000000000001 0.6812957523832152 0.6812939746377437 -9.552225719994256e-07 -0.08566507641882809 -0.843 0.6813031600380968 0.6813014013057019 -9.607012050466546e-07 -0.08566911906001098 -0.8431000000000001 0.6813105656271593 0.6813088260173965 -9.65981831496654e-07 -0.08567316064909163 -0.8432000000000001 0.6813179691529395 0.6813162487712441 -9.710633552123538e-07 -0.08567720118629413 -0.8433 0.6813253706179851 0.6813236695656509 -9.759447229806817e-07 -0.08568124067184274 -0.8434 0.6813327700248542 0.6813310883990126 -9.806249246235854e-07 -0.08568527910596153 -0.8435 0.6813401673761148 0.6813385052697145 -9.85102993233955e-07 -0.08568931648887473 -0.8436 0.681347562674345 0.6813459201761325 -9.893780053837897e-07 -0.08569335282080642 -0.8437 0.681354955922131 0.681353333116633 -9.934490813601204e-07 -0.08569738810198074 -0.8438000000000001 0.6813623471220687 0.6813607440895733 -9.973153850539873e-07 -0.08570142233262167 -0.8439000000000001 0.6813697362767617 0.6813681530933032 -1.0009761246543292e-06 -0.08570545551295339 -0.844 0.6813771233888213 0.6813755601261637 -1.0044305523981834e-06 -0.08570948764319983 -0.8441000000000001 0.6813845084608658 0.6813829651864889 -1.007677964875997e-06 -0.08571351872358501 -0.8442000000000001 0.6813918914955213 0.6813903682726057 -1.0107177031981607e-06 -0.08571754875433296 -0.8443 0.6813992724954192 0.6813977693828347 -1.0135491530782748e-06 -0.08572157773566769 -0.8444 0.6814066514631973 0.6814051685154906 -1.0161717449719276e-06 -0.08572560566781316 -0.8445 0.6814140284014989 0.6814125656688819 -1.0185849541599623e-06 -0.08572963255099325 -0.8446 0.6814214033129717 0.6814199608413125 -1.0207883009427654e-06 -0.08573365838543186 -0.8447 0.6814287762002691 0.6814273540310813 -1.0227813505014893e-06 -0.08573768317135295 -0.8448000000000001 0.681436147066047 0.6814347452364835 -1.0245637134531638e-06 -0.08574170690898036 -0.8449000000000001 0.681443515912966 0.68144213445581 -1.0261350454898732e-06 -0.08574572959853798 -0.845 0.6814508827436896 0.681449521687349 -1.0274950475175348e-06 -0.08574975124024961 -0.8451000000000001 0.6814582475608832 0.6814569069293858 -1.0286434660444765e-06 -0.08575377183433913 -0.8452000000000001 0.6814656103672156 0.6814642901802028 -1.0295800926818366e-06 -0.08575779138103029 -0.8453 0.6814729711653561 0.6814716714380817 -1.030304764643164e-06 -0.0857618098805469 -0.8454 0.6814803299579759 0.6814790507013015 -1.030817364577885e-06 -0.08576582733311267 -0.8455 0.6814876867477465 0.6814864279681416 -1.0311178206545701e-06 -0.08576984373895138 -0.8456 0.6814950415373403 0.68149380323688 -1.0312061065054223e-06 -0.08577385909828675 -0.8457 0.6815023943294289 0.6815011765057952 -1.0310822411707665e-06 -0.08577787341134246 -0.8458000000000001 0.6815097451266834 0.6815085477731659 -1.0307462893488495e-06 -0.08578188667834218 -0.8459000000000001 0.6815170939317741 0.6815159170372723 -1.0301983610350174e-06 -0.0857858988995096 -0.846 0.6815244407473691 0.6815232842963956 -1.0294386118825383e-06 -0.08578991007506832 -0.8461000000000001 0.681531785576135 0.6815306495488194 -1.0284672426752461e-06 -0.08579392020524201 -0.8462000000000001 0.6815391284207354 0.6815380127928292 -1.0272844996883634e-06 -0.08579792929025426 -0.8463 0.681546469283831 0.6815453740267134 -1.025890674494212e-06 -0.0858019373303286 -0.8464 0.6815538081680794 0.6815527332487643 -1.0242861038511908e-06 -0.08580594432568867 -0.8465 0.6815611450761333 0.6815600904572775 -1.0224711696760203e-06 -0.0858099502765579 -0.8466 0.6815684800106421 0.6815674456505529 -1.0204462987661866e-06 -0.08581395518315989 -0.8467 0.6815758129742499 0.6815747988268954 -1.0182119632162756e-06 -0.08581795904571815 -0.8468000000000001 0.6815831439695947 0.6815821499846146 -1.0157686796685717e-06 -0.08582196186445606 -0.8469000000000001 0.6815904729993099 0.6815894991220264 -1.013117009590614e-06 -0.08582596363959714 -0.847 0.6815978000660217 0.6815968462374523 -1.0102575591086627e-06 -0.08582996437136481 -0.8471000000000001 0.6816051251723501 0.681604191329221 -1.007190978841166e-06 -0.08583396405998252 -0.8472000000000001 0.6816124483209077 0.6816115343956677 -1.0039179635656925e-06 -0.08583796270567366 -0.8473 0.6816197695142996 0.6816188754351354 -1.0004392523021988e-06 -0.08584196030866162 -0.8474 0.6816270887551223 0.6816262144459746 -9.96755628146495e-07 -0.08584595686916974 -0.8475 0.6816344060459645 0.681633551426545 -9.928679179649347e-07 -0.08584995238742135 -0.8476 0.6816417213894048 0.6816408863752146 -9.887769923111467e-07 -0.08585394686363973 -0.8477 0.6816490347880135 0.6816482192903608 -9.844837650097027e-07 -0.08585794029804826 -0.8478000000000001 0.6816563462443505 0.6816555501703707 -9.799891933781613e-07 -0.08586193269087015 -0.8479000000000001 0.6816636557609648 0.6816628790136419 -9.752942776442008e-07 -0.08586592404232864 -0.848 0.6816709633403956 0.6816702058185826 -9.70400060862353e-07 -0.08586991435264704 -0.8481000000000001 0.6816782689851701 0.6816775305836118 -9.653076286642026e-07 -0.08587390362204855 -0.8482000000000001 0.6816855726978042 0.6816848533071606 -9.600181091612425e-07 -0.08587789185075632 -0.8483 0.6816928744808011 0.6816921739876711 -9.545326724175185e-07 -0.08588187903899351 -0.8484 0.6817001743366522 0.681699492623599 -9.488525303802398e-07 -0.08588586518698332 -0.8485 0.6817074722678356 0.681706809213412 -9.429789365050789e-07 -0.08588985029494887 -0.8486 0.681714768276816 0.6817141237555915 -9.369131857006607e-07 -0.0858938343631133 -0.8487 0.6817220623660438 0.6817214362486322 -9.30656613815084e-07 -0.08589781739169966 -0.8488000000000001 0.6817293545379559 0.6817287466910434 -9.242105974693882e-07 -0.08590179938093101 -0.8489000000000001 0.681736644794974 0.6817360550813488 -9.175765536412195e-07 -0.08590578033103047 -0.849 0.6817439331395048 0.6817433614180866 -9.107559394289089e-07 -0.085909760242221 -0.8491000000000001 0.6817512195739397 0.6817506656998109 -9.037502518155494e-07 -0.08591373911472563 -0.8492000000000001 0.6817585041006536 0.6817579679250914 -8.965610272249069e-07 -0.08591771694876735 -0.8493 0.6817657867220059 0.6817652680925137 -8.891898411605981e-07 -0.08592169374456915 -0.8494 0.6817730674403387 0.681772566200681 -8.816383079562895e-07 -0.085925669502354 -0.8495 0.6817803462579768 0.6817798622482122 -8.739080804287536e-07 -0.08592964422234477 -0.8496 0.681787623177228 0.6817871562337443 -8.660008494199012e-07 -0.08593361790476436 -0.8497 0.6817948982003819 0.6817944481559319 -8.579183435053483e-07 -0.08593759054983574 -0.8498000000000001 0.6818021713297098 0.6818017380134478 -8.496623285364491e-07 -0.08594156215778175 -0.8499000000000001 0.6818094425674643 0.6818090258049831 -8.41234607473762e-07 -0.08594553272882517 -0.85 0.6818167119158789 0.6818163115292482 -8.326370197486721e-07 -0.08594950226318886 -0.8501000000000001 0.6818239793771678 0.6818235951849724 -8.238714409025683e-07 -0.08595347076109561 -0.8502000000000001 0.6818312449535251 0.681830876770905 -8.149397822954096e-07 -0.08595743822276819 -0.8503000000000001 0.6818385086471253 0.6818381562858153 -8.058439906200032e-07 -0.08596140464842941 -0.8504 0.6818457704601217 0.6818454337284932 -7.965860474995479e-07 -0.08596537003830204 -0.8505 0.6818530303946468 0.6818527090977485 -7.87167968988034e-07 -0.08596933439260869 -0.8506 0.6818602884528121 0.6818599823924133 -7.775918052232988e-07 -0.08597329771157217 -0.8507 0.6818675446367075 0.6818672536113402 -7.678596399829374e-07 -0.08597725999541508 -0.8508000000000001 0.6818747989484006 0.681874522753404 -7.579735901430684e-07 -0.08598122124436015 -0.8509000000000001 0.6818820513899371 0.6818817898175019 -7.479358052620011e-07 -0.08598518145862999 -0.851 0.6818893019633396 0.681889054802553 -7.377484672194123e-07 -0.0859891406384472 -0.8511 0.6818965506706084 0.6818963177074995 -7.274137894808241e-07 -0.08599309878403436 -0.8512000000000001 0.68190379751372 0.6819035785313068 -7.169340170282146e-07 -0.0859970558956141 -0.8513000000000001 0.6819110424946273 0.6819108372729638 -7.063114253330616e-07 -0.08600101197340895 -0.8514 0.6819182856152595 0.6819180939314828 -6.955483204534874e-07 -0.0860049670176414 -0.8515 0.6819255268775215 0.6819253485059007 -6.8464703802118e-07 -0.08600892102853404 -0.8516 0.6819327662832937 0.6819326009952784 -6.736099431164932e-07 -0.08601287400630936 -0.8517 0.6819400038344315 0.6819398513987018 -6.624394294496572e-07 -0.08601682595118978 -0.8518000000000001 0.6819472395327655 0.6819470997152812 -6.511379190971001e-07 -0.08602077686339776 -0.8519000000000001 0.6819544733801004 0.6819543459441528 -6.397078619185814e-07 -0.08602472674315574 -0.852 0.6819617053782157 0.681961590084478 -6.281517347939136e-07 -0.08602867559068611 -0.8521 0.6819689355288646 0.6819688321354441 -6.164720414703062e-07 -0.08603262340621132 -0.8522000000000001 0.6819761638337742 0.6819760720962644 -6.046713117435765e-07 -0.08603657018995364 -0.8523000000000001 0.681983390294645 0.6819833099661794 -5.927521009169157e-07 -0.08604051594213552 -0.8524 0.6819906149131507 0.6819905457444545 -5.807169894400666e-07 -0.08604446066297917 -0.8525 0.6819978376909382 0.6819977794303838 -5.685685821876785e-07 -0.08604840435270703 -0.8526 0.6820050586296267 0.682005011023287 -5.563095079874625e-07 -0.08605234701154124 -0.8527 0.6820122777308084 0.6820122405225124 -5.439424189124242e-07 -0.08605628863970416 -0.8528000000000001 0.6820194949960472 0.6820194679274354 -5.314699899200415e-07 -0.08606022923741799 -0.8529000000000001 0.6820267104268795 0.682026693237459 -5.188949180195968e-07 -0.08606416880490497 -0.853 0.682033924024813 0.6820339164520146 -5.062199219668662e-07 -0.08606810734238729 -0.8531 0.6820411357913276 0.6820411375705617 -4.934477414661465e-07 -0.08607204485008715 -0.8532000000000001 0.6820483457278739 0.6820483565925887 -4.805811367053492e-07 -0.08607598132822668 -0.8533000000000001 0.682055553835874 0.6820555735176119 -4.6762288764129467e-07 -0.08607991677702799 -0.8534 0.6820627601167208 0.6820627883451775 -4.5457579351398936e-07 -0.08608385119671326 -0.8535 0.6820699645717783 0.6820700010748599 -4.4144267216661426e-07 -0.0860877845875045 -0.8536 0.6820771672023804 0.6820772117062632 -4.282263594418412e-07 -0.08609171694962388 -0.8537 0.6820843680098319 0.682084420239021 -4.1492970868223233e-07 -0.08609564828329336 -0.8538000000000001 0.6820915669954075 0.6820916266727965 -4.015555899183898e-07 -0.08609957858873496 -0.8539000000000001 0.6820987641603524 0.6820988310072827 -3.8810688945262184e-07 -0.08610350786617073 -0.854 0.6821059595058813 0.6821060332422026 -3.745865091095424e-07 -0.08610743611582267 -0.8541 0.6821131530331785 0.6821132333773092 -3.609973656115706e-07 -0.08611136333791272 -0.8542000000000001 0.6821203447433981 0.6821204314123861 -3.4734239004463596e-07 -0.08611528953266283 -0.8543000000000001 0.6821275346376638 0.6821276273472471 -3.336245270671445e-07 -0.08611921470029496 -0.8544 0.6821347227170682 0.6821348211817364 -3.198467344658895e-07 -0.08612313884103094 -0.8545 0.6821419089826735 0.6821420129157292 -3.0601198238583427e-07 -0.08612706195509275 -0.8546 0.6821490934355101 0.6821492025491314 -2.9212325274030615e-07 -0.08613098404270214 -0.8547 0.6821562760765785 0.6821563900818797 -2.781835385101683e-07 -0.08613490510408106 -0.8548000000000001 0.6821634569068469 0.6821635755139419 -2.6419584321993317e-07 -0.08613882513945119 -0.8549000000000001 0.6821706359272528 0.682170758845317 -2.501631801953008e-07 -0.08614274414903439 -0.855 0.6821778131387026 0.6821779400760354 -2.360885718935557e-07 -0.08614666213305247 -0.8551 0.6821849885420703 0.6821851192061583 -2.2197504935886347e-07 -0.08615057909172712 -0.8552000000000001 0.6821921621381994 0.6821922962357793 -2.0782565145552323e-07 -0.08615449502528014 -0.8553000000000001 0.6821993339279008 0.6821994711650221 -1.936434242851004e-07 -0.08615840993393316 -0.8554 0.682206503911954 0.6822066439940432 -1.7943142053070127e-07 -0.0861623238179079 -0.8555 0.6822136720911074 0.6822138147230302 -1.651926987457364e-07 -0.08616623667742605 -0.8556 0.6822208384660765 0.6822209833522022 -1.5093032274676732e-07 -0.08617014851270921 -0.8557 0.6822280030375457 0.6822281498818102 -1.3664736093349505e-07 -0.08617405932397904 -0.8558000000000001 0.6822351658061674 0.6822353143121376 -1.223468856451776e-07 -0.08617796911145716 -0.8559000000000001 0.6822423267725615 0.6822424766434982 -1.0803197247541418e-07 -0.08618187787536508 -0.856 0.6822494859373163 0.682249636876239 -9.370569962682818e-08 -0.08618578561592441 -0.8561 0.6822566433009882 0.682256795010738 -7.937114725187211e-08 -0.08618969233335669 -0.8562000000000001 0.6822637988641015 0.6822639510474056 -6.503139677108138e-08 -0.0861935980278834 -0.8563000000000001 0.6822709526271484 0.6822711049866834 -5.0689530235129704e-08 -0.08619750269972605 -0.8564 0.6822781045905892 0.6822782568290457 -3.634862964573904e-08 -0.08620140634910615 -0.8565 0.682285254754852 0.6822854065749983 -2.201177629859892e-08 -0.08620530897624508 -0.8566 0.682292403120333 0.6822925542250784 -7.682050121027295e-09 -0.08620921058136433 -0.8567 0.6822995496873965 0.6822996997798558 6.637470990368544e-09 -0.08621311116468529 -0.8568000000000001 0.6823066944563745 0.6823068432399318 2.094371182991689e-08 -0.08621701072642933 -0.8569000000000001 0.6823138374275675 0.6823139846059392 3.523360053714342e-08 -0.08622090926681779 -0.857 0.682320978601244 0.682321123878543 4.9504069274397544e-08 -0.08622480678607208 -0.8571 0.6823281179776403 0.6823282610584396 6.37520548713022e-08 -0.08622870328441347 -0.8572000000000001 0.6823352555569613 0.6823353961463571 7.797449949262236e-08 -0.08623259876206328 -0.8573000000000001 0.6823423913393801 0.682342529143055 9.216835127057177e-08 -0.08623649321924277 -0.8574 0.6823495253250382 0.6823496600493248 1.0633056499176341e-07 -0.08624038665617323 -0.8575 0.6823566575140452 0.6823567888659889 1.204581027459961e-07 -0.0862442790730758 -0.8576 0.6823637879064794 0.6823639155939014 1.3454793455075498e-07 -0.08624817047017178 -0.8577 0.682370916502388 0.6823710402339476 1.4859703902081467e-07 -0.08625206084768233 -0.8578000000000001 0.6823780433017863 0.6823781627870437 1.626024040274343e-07 -0.08625595020582864 -0.8579000000000001 0.682385168304659 0.6823852832541374 1.7656102732979684e-07 -0.08625983854483188 -0.858 0.682392291510959 0.6823924016362071 1.9046991722726503e-07 -0.08626372586491311 -0.8581 0.682399412920609 0.6823995179342619 2.0432609318388195e-07 -0.0862676121662935 -0.8582000000000001 0.6824065325334998 0.682406632149342 2.181265864875659e-07 -0.08627149744919407 -0.8583000000000001 0.6824136503494922 0.682413744282518 2.3186844086420244e-07 -0.0862753817138359 -0.8584 0.6824207663684163 0.6824208543348909 2.455487131680645e-07 -0.08627926496044003 -0.8585 0.6824278805900716 0.6824279623075917 2.5916447394386255e-07 -0.08628314718922746 -0.8586 0.6824349930142277 0.6824350682017826 2.727128080651231e-07 -0.0862870284004192 -0.8587 0.6824421036406233 0.6824421720186551 2.861908153933834e-07 -0.08629090859423628 -0.8588000000000001 0.6824492124689673 0.6824492737594303 2.995956113888143e-07 -0.08629478777089956 -0.8589000000000001 0.682456319498939 0.682456373425359 3.1292432772778156e-07 -0.08629866593062992 -0.859 0.682463424730188 0.6824634710177224 3.261741128926521e-07 -0.08630254307364837 -0.8591 0.6824705281623344 0.6824705665378306 3.3934213277547753e-07 -0.0863064192001758 -0.8592000000000001 0.6824776297949686 0.6824776599870221 3.524255713927005e-07 -0.08631029431043297 -0.8593000000000001 0.6824847296276527 0.6824847513666659 3.6542163134312133e-07 -0.08631416840464085 -0.8594 0.682491827659919 0.682491840678158 3.7832753446015444e-07 -0.08631804148302014 -0.8595 0.6824989238912713 0.6824989279229243 3.911405224987785e-07 -0.0863219135457917 -0.8596 0.6825060183211855 0.6825060131024185 4.038578575449314e-07 -0.08632578459317626 -0.8597 0.6825131109491089 0.6825130962181223 4.1647682274409403e-07 -0.08632965462539466 -0.8598000000000001 0.6825202017744605 0.6825201772715459 4.2899472284252393e-07 -0.08633352364266758 -0.8599000000000001 0.6825272907966313 0.6825272562642265 4.4140888476318363e-07 -0.0863373916452157 -0.86 0.6825343780149855 0.6825343331977289 4.5371665814697426e-07 -0.0863412586332597 -0.8601 0.6825414634288592 0.6825414080736454 4.6591541598417496e-07 -0.0863451246070203 -0.8602000000000001 0.6825485470375614 0.6825484808935951 4.780025551209821e-07 -0.08634898956671805 -0.8603000000000001 0.6825556288403751 0.6825555516592239 4.89975496870132e-07 -0.0863528535125737 -0.8604 0.6825627088365557 0.6825626203722037 5.018316874133566e-07 -0.08635671644480775 -0.8605 0.6825697870253324 0.6825696870342333 5.135685985785399e-07 -0.08636057836364075 -0.8606 0.6825768634059093 0.6825767516470367 5.251837282421734e-07 -0.08636443926929332 -0.8607 0.6825839379774634 0.6825838142123641 5.366746008428347e-07 -0.08636829916198598 -0.8608000000000001 0.6825910107391471 0.6825908747319905 5.480387679640542e-07 -0.08637215804193918 -0.8609000000000001 0.6825980816900873 0.6825979332077168 5.592738088339155e-07 -0.08637601590937351 -0.861 0.6826051508293859 0.682604989641368 5.70377330907923e-07 -0.08637987276450937 -0.8611 0.68261221815612 0.6826120440347936 5.813469702575791e-07 -0.08638372860756723 -0.8612000000000001 0.6826192836693428 0.6826190963898675 5.921803921810076e-07 -0.08638758343876744 -0.8613000000000001 0.6826263473680829 0.6826261467084873 6.028752916609204e-07 -0.08639143725833043 -0.8614 0.6826334092513457 0.6826331949925746 6.134293938225843e-07 -0.08639529006647656 -0.8615 0.6826404693181132 0.6826402412440737 6.238404544611775e-07 -0.08639914186342623 -0.8616 0.682647527567344 0.6826472854649523 6.341062605275116e-07 -0.08640299264939978 -0.8617 0.6826545839979741 0.6826543276572006 6.442246305859989e-07 -0.08640684242461746 -0.8618000000000001 0.6826616386089168 0.6826613678228305 6.541934152726192e-07 -0.0864106911892996 -0.8619000000000001 0.6826686913990643 0.6826684059638763 6.640104977390093e-07 -0.08641453894366642 -0.862 0.6826757423672856 0.6826754420823941 6.73673794165941e-07 -0.08641838568793819 -0.8621 0.6826827915124294 0.6826824761804609 6.831812540686322e-07 -0.08642223142233511 -0.8622000000000001 0.6826898388333229 0.6826895082601745 6.925308609490033e-07 -0.08642607614707737 -0.8623000000000001 0.6826968843287726 0.6826965383236534 7.017206325038439e-07 -0.08642991986238513 -0.8624 0.682703927997565 0.6827035663730364 7.107486212076797e-07 -0.08643376256847857 -0.8625 0.6827109698384664 0.6827105924104819 7.196129146319619e-07 -0.0864376042655778 -0.8626 0.6827180098502236 0.6827176164381683 7.283116359446673e-07 -0.08644144495390296 -0.8627 0.6827250480315641 0.6827246384582923 7.368429441600988e-07 -0.08644528463367412 -0.8628000000000001 0.6827320843811961 0.6827316584730698 7.452050346662409e-07 -0.08644912330511134 -0.8629000000000001 0.6827391188978105 0.6827386764847344 7.533961395161937e-07 -0.08645296096843465 -0.863 0.6827461515800789 0.6827456924955384 7.614145279555284e-07 -0.08645679762386405 -0.8631 0.6827531824266557 0.6827527065077512 7.692585065749435e-07 -0.08646063327161953 -0.8632000000000001 0.6827602114361782 0.6827597185236596 7.769264198237424e-07 -0.08646446791192107 -0.8633000000000001 0.6827672386072663 0.682766728545567 7.844166502873895e-07 -0.08646830154498862 -0.8634000000000001 0.6827742639385241 0.6827737365757931 7.91727619076088e-07 -0.08647213417104213 -0.8635 0.6827812874285386 0.6827807426166737 7.98857786171725e-07 -0.08647596579030145 -0.8636 0.682788309075882 0.6827877466705603 8.0580565062216e-07 -0.08647979640298653 -0.8637 0.6827953288791108 0.682794748739819 8.125697510685814e-07 -0.08648362600931717 -0.8638000000000001 0.6828023468367665 0.6828017488268313 8.19148665814895e-07 -0.08648745460951324 -0.8639000000000001 0.6828093629473765 0.6828087469339926 8.255410134105912e-07 -0.08649128220379454 -0.864 0.6828163772094539 0.6828157430637122 8.317454526923784e-07 -0.08649510879238083 -0.8641 0.6828233896214979 0.682822737218413 8.377606832143947e-07 -0.0864989343754919 -0.8642000000000001 0.6828304001819951 0.682829729400531 8.43585445331474e-07 -0.0865027589533475 -0.8643000000000001 0.6828374088894194 0.6828367196125145 8.492185208514025e-07 -0.08650658252616733 -0.8644000000000001 0.6828444157422313 0.6828437078568244 8.546587328267519e-07 -0.08651040509417113 -0.8645 0.6828514207388805 0.6828506941359334 8.59904946082235e-07 -0.08651422665757852 -0.8646 0.6828584238778047 0.6828576784523249 8.649560674089951e-07 -0.08651804721660923 -0.8647 0.6828654251574306 0.6828646608084938 8.698110457033836e-07 -0.08652186677148281 -0.8648 0.6828724245761744 0.6828716412069455 8.74468872438805e-07 -0.08652568532241892 -0.8649000000000001 0.6828794221324422 0.6828786196501949 8.789285815546943e-07 -0.08652950286963713 -0.865 0.6828864178246299 0.6828855961407668 8.831892497895844e-07 -0.08653331941335697 -0.8651 0.6828934116511246 0.682892570681195 8.872499969447833e-07 -0.086537134953798 -0.8652000000000001 0.682900403610305 0.6828995432740224 8.911099858566196e-07 -0.0865409494911798 -0.8653000000000001 0.6829073937005402 0.6829065139217991 8.947684230209418e-07 -0.08654476302572178 -0.8654000000000001 0.6829143819201924 0.6829134826270842 8.982245582045412e-07 -0.08654857555764342 -0.8655 0.682921368267616 0.682920449392443 9.014776848892403e-07 -0.0865523870871642 -0.8656 0.682928352741158 0.6829274142204488 9.045271404939381e-07 -0.0865561976145035 -0.8657 0.68293533533916 0.6829343771136803 9.07372306291343e-07 -0.0865600071398808 -0.8658 0.6829423160599559 0.6829413380747227 9.100126076855286e-07 -0.08656381566351538 -0.8659000000000001 0.6829492949018754 0.6829482971061664 9.124475142674449e-07 -0.08656762318562666 -0.866 0.682956271863242 0.6829552542106074 9.146765399259404e-07 -0.08657142970643397 -0.8661 0.6829632469423752 0.6829622093906456 9.166992430698073e-07 -0.08657523522615665 -0.8662000000000001 0.6829702201375896 0.6829691626488852 9.185152265167584e-07 -0.08657903974501392 -0.8663000000000001 0.6829771914471962 0.6829761139879341 9.201241376599611e-07 -0.08658284326322507 -0.8664000000000001 0.6829841608695031 0.6829830634104035 9.21525668551304e-07 -0.08658664578100936 -0.8665 0.682991128402815 0.6829900109189071 9.227195558736412e-07 -0.08659044729858599 -0.8666 0.6829980940454347 0.6829969565160612 9.237055812738593e-07 -0.08659424781617416 -0.8667 0.6830050577956621 0.6830039002044832 9.244835709742993e-07 -0.08659804733399301 -0.8668 0.683012019651797 0.6830108419867926 9.250533961335794e-07 -0.08660184585226177 -0.8669000000000001 0.683018979612137 0.6830177818656096 9.25414972735572e-07 -0.0866056433711995 -0.867 0.6830259376749797 0.6830247198435544 9.255682617004268e-07 -0.08660943989102532 -0.8671 0.6830328938386224 0.6830316559232474 9.25513268829059e-07 -0.08661323541195833 -0.8672000000000001 0.6830398481013631 0.6830385901073085 9.252500445811052e-07 -0.08661702993421753 -0.8673000000000001 0.6830468004615005 0.6830455223983563 9.247786844357453e-07 -0.08662082345802201 -0.8674000000000001 0.6830537509173343 0.6830524527990083 9.240993286141475e-07 -0.08662461598359077 -0.8675 0.6830606994671665 0.68305938131188 9.232121622737566e-07 -0.08662840751114281 -0.8676 0.683067646109301 0.6830663079395844 9.22117414953183e-07 -0.08663219804089707 -0.8677 0.6830745908420446 0.6830732326847317 9.20815361127314e-07 -0.08663598757307248 -0.8678 0.6830815336637069 0.6830801555499285 9.193063198742468e-07 -0.08663977610788798 -0.8679000000000001 0.6830884745726018 0.683087076537778 9.175906547087553e-07 -0.08664356364556247 -0.868 0.6830954135670464 0.683093995650879 9.156687736933122e-07 -0.08664735018631481 -0.8681 0.6831023506453634 0.6831009128918257 9.135411291327777e-07 -0.08665113573036384 -0.8682000000000001 0.6831092858058795 0.6831078282632068 9.112082176021552e-07 -0.0866549202779284 -0.8683000000000001 0.6831162190469278 0.6831147417676058 9.086705798910799e-07 -0.0866587038292273 -0.8684000000000001 0.6831231503668465 0.6831216534075997 9.059288007540189e-07 -0.08666248638447933 -0.8685 0.6831300797639805 0.6831285631857593 9.029835087992488e-07 -0.08666626794390318 -0.8686 0.683137007236682 0.6831354711046485 8.998353764333444e-07 -0.08667004850771766 -0.8687 0.68314393278331 0.6831423771668232 8.964851195836232e-07 -0.08667382807614146 -0.8688 0.6831508564022313 0.683149281374832 8.929334976981451e-07 -0.08667760664939328 -0.8689000000000001 0.6831577780918205 0.6831561837312146 8.891813133848903e-07 -0.0866813842276917 -0.869 0.6831646978504617 0.6831630842385024 8.852294123840032e-07 -0.0866851608112554 -0.8691 0.6831716156765477 0.6831699828992172 8.810786832902373e-07 -0.08668893640030305 -0.8692000000000001 0.6831785315684806 0.6831768797158713 8.767300574558101e-07 -0.08669271099505318 -0.8693000000000001 0.6831854455246728 0.6831837746909672 8.72184508560192e-07 -0.08669648459572442 -0.8694000000000001 0.6831923575435468 0.6831906678269961 8.67443052693373e-07 -0.08670025720253527 -0.8695 0.6831992676235364 0.6831975591264385 8.625067480366733e-07 -0.08670402881570426 -0.8696 0.6832061757630863 0.6832044485917639 8.573766944047767e-07 -0.0867077994354499 -0.8697 0.6832130819606528 0.6832113362254293 8.520540332734861e-07 -0.08671156906199064 -0.8698 0.6832199862147044 0.6832182220298797 8.465399474466562e-07 -0.08671533769554494 -0.8699000000000001 0.6832268885237227 0.6832251060075474 8.408356607786382e-07 -0.08671910533633123 -0.87 0.6832337888862019 0.6832319881608516 8.349424377857018e-07 -0.08672287198456793 -0.8701 0.6832406873006497 0.6832388684921977 8.288615837709346e-07 -0.08672663764047345 -0.8702000000000001 0.6832475837655876 0.6832457470039776 8.225944439360644e-07 -0.08673040230426614 -0.8703000000000001 0.6832544782795511 0.6832526236985679 8.161424036173814e-07 -0.08673416597616428 -0.8704000000000001 0.6832613708410906 0.6832594985783312 8.095068876196043e-07 -0.08673792865638624 -0.8705 0.6832682614487717 0.6832663716456147 8.026893601603691e-07 -0.08674169034515028 -0.8706 0.6832751501011751 0.6832732429027499 7.956913243706287e-07 -0.08674545104267467 -0.8707 0.6832820367968977 0.683280112352052 7.885143220309754e-07 -0.08674921074917762 -0.8708 0.6832889215345526 0.68328697999582 7.811599332802066e-07 -0.08675296946487736 -0.8709000000000001 0.6832958043127695 0.6832938458363362 7.736297762683808e-07 -0.08675672718999207 -0.871 0.6833026851301951 0.6833007098758661 7.65925506643339e-07 -0.08676048392474002 -0.8711 0.683309563985494 0.6833075721166562 7.580488174258049e-07 -0.08676423966933926 -0.8712000000000001 0.6833164408773482 0.6833144325609364 7.500014384126397e-07 -0.08676799442400794 -0.8713000000000001 0.6833233158044577 0.6833212912109177 7.4178513594092e-07 -0.08677174818896416 -0.8714000000000001 0.6833301887655416 0.6833281480687922 7.334017124716041e-07 -0.08677550096442599 -0.8715 0.6833370597593376 0.6833350031367333 7.248530061731984e-07 -0.08677925275061146 -0.8716 0.6833439287846029 0.6833418564168945 7.16140890533179e-07 -0.08678300354773866 -0.8717 0.6833507958401146 0.68334870791141 7.072672739832919e-07 -0.08678675335602555 -0.8718 0.6833576609246694 0.683355557622393 6.982340993860747e-07 -0.08679050217569012 -0.8719000000000001 0.6833645240370846 0.683362405551937 6.890433437711785e-07 -0.08679425000695035 -0.872 0.6833713851761983 0.6833692517021137 6.796970176831119e-07 -0.08679799685002415 -0.8721 0.6833782443408698 0.6833760960749745 6.701971649591965e-07 -0.08680174270512946 -0.8722000000000001 0.6833851015299794 0.6833829386725487 6.605458621605775e-07 -0.08680548757248414 -0.8723000000000001 0.6833919567424296 0.6833897794968433 6.507452181558904e-07 -0.08680923145230597 -0.8724000000000001 0.6833988099771449 0.6833966185498437 6.40797373677171e-07 -0.08681297434481294 -0.8725 0.6834056612330723 0.6834034558335127 6.307045007786227e-07 -0.0868167162502228 -0.8726 0.6834125105091815 0.6834102913497896 6.204688025174265e-07 -0.08682045716875333 -0.8727 0.6834193578044649 0.6834171251005909 6.100925122320966e-07 -0.08682419710062232 -0.8728 0.6834262031179391 0.6834239570878093 5.995778933343132e-07 -0.08682793604604745 -0.8729000000000001 0.6834330464486436 0.6834307873133143 5.889272385595223e-07 -0.08683167400524651 -0.873 0.6834398877956422 0.6834376157789505 5.781428696893798e-07 -0.08683541097843717 -0.8731 0.6834467271580233 0.6834444424865382 5.672271368994952e-07 -0.08683914696583715 -0.8732000000000001 0.6834535645348996 0.6834512674378732 5.56182418315343e-07 -0.086842881967664 -0.8733000000000001 0.6834603999254083 0.6834580906347265 5.450111194432727e-07 -0.08684661598413547 -0.8734000000000001 0.6834672333287124 0.6834649120788432 5.337156727264203e-07 -0.08685034901546908 -0.8735 0.6834740647439999 0.6834717317719432 5.222985369618405e-07 -0.08685408106188242 -0.8736 0.6834808941704845 0.6834785497157204 5.107621966760068e-07 -0.08685781212359306 -0.8737 0.6834877216074062 0.6834853659118426 4.991091618472554e-07 -0.08686154220081849 -0.8738 0.6834945470540306 0.6834921803619514 4.873419670592405e-07 -0.08686527129377619 -0.8739000000000001 0.6835013705096504 0.6834989930676619 4.7546317115398917e-07 -0.08686899940268378 -0.874 0.6835081919735848 0.6835058040305617 4.634753566351568e-07 -0.08687272652775857 -0.8741 0.6835150114451798 0.6835126132522118 4.513811290296488e-07 -0.08687645266921805 -0.8742000000000001 0.6835218289238086 0.6835194207341457 4.391831163463866e-07 -0.08688017782727961 -0.8743000000000001 0.6835286444088722 0.6835262264778701 4.268839686044634e-07 -0.08688390200216072 -0.8744000000000001 0.6835354578997985 0.6835330304848619 4.1448635718088767e-07 -0.08688762519407858 -0.8745 0.6835422693960442 0.6835398327565723 4.019929741999606e-07 -0.08689134740325066 -0.8746 0.6835490788970934 0.6835466332944229 3.8940653199898145e-07 -0.0868950686298943 -0.8747 0.6835558864024585 0.6835534320998076 3.7672976253844137e-07 -0.0868987888742267 -0.8748 0.6835626919116804 0.6835602291740908 3.639654168052786e-07 -0.0869025081364651 -0.8749000000000001 0.683569495424329 0.6835670245186087 3.511162642230725e-07 -0.08690622641682683 -0.875 0.6835762969400028 0.683573818134669 3.381850919997875e-07 -0.08690994371552908 -0.8751 0.6835830964583292 0.6835806100235489 3.251747045726616e-07 -0.08691366003278901 -0.8752000000000001 0.683589893978965 0.6835874001864974 3.1208792303921706e-07 -0.08691737536882382 -0.8753000000000001 0.6835966895015961 0.6835941886247334 2.9892758447030987e-07 -0.08692108972385065 -0.8754000000000001 0.6836034830259388 0.6836009753394459 2.8569654129950717e-07 -0.08692480309808659 -0.8755 0.6836102745517378 0.6836077603317953 2.72397660747159e-07 -0.08692851549174886 -0.8756 0.6836170640787685 0.6836145436029103 2.590338241958978e-07 -0.0869322269050544 -0.8757 0.6836238516068358 0.6836213251538905 2.456079265383826e-07 -0.08693593733822023 -0.8758 0.6836306371357751 0.6836281049858051 2.3212287559443157e-07 -0.08693964679146345 -0.8759000000000001 0.6836374206654522 0.6836348830996929 2.1858159143794964e-07 -0.0869433552650011 -0.876 0.6836442021957625 0.683641659496562 2.0498700573079454e-07 -0.08694706275905008 -0.8761 0.6836509817266325 0.6836484341773902 1.9134206120235975e-07 -0.08695076927382739 -0.8762000000000001 0.6836577592580191 0.6836552071431241 1.776497109209907e-07 -0.08695447480954993 -0.8763000000000001 0.6836645347899097 0.6836619783946799 1.639129176972398e-07 -0.08695817936643459 -0.8764000000000001 0.6836713083223229 0.6836687479329426 1.5013465340038556e-07 -0.08696188294469825 -0.8765 0.6836780798553078 0.6836755157587664 1.363178983686264e-07 -0.0869655855445578 -0.8766 0.6836848493889447 0.683682281872974 1.2246564073253863e-07 -0.08696928716623005 -0.8767 0.6836916169233448 0.6836890462763575 1.0858087577322872e-07 -0.08697298780993185 -0.8768 0.6836983824586502 0.6836958089696771 9.46666052839551e-08 -0.08697668747587989 -0.8769000000000001 0.683705145995035 0.683702569953662 8.072583690746371e-08 -0.08698038616429099 -0.877 0.683711907532703 0.68370932922901 6.676158348720151e-08 -0.08698408387538184 -0.8771 0.6837186670718908 0.6837160867963878 5.2776862442815986e-08 -0.08698778060936924 -0.8772000000000001 0.6837254246128653 0.6837228426564304 3.8774695078000465e-08 -0.08699147636646977 -0.8773000000000001 0.6837321801559255 0.6837295968097408 2.4758105957728427e-08 -0.08699517114690014 -0.8774000000000001 0.683738933701401 0.6837363492568912 1.073012224385439e-08 -0.086998864950877 -0.8775 0.6837456852496534 0.6837430999984218 -3.306226964081005e-09 -0.08700255777861687 -0.8776 0.6837524348010755 0.6837498490348417 -1.7347911263759785e-08 -0.0870062496303365 -0.8777 0.6837591823560912 0.6837565963666281 -3.13918996335677e-08 -0.08700994050625233 -0.8778 0.6837659279151564 0.6837633419942266 -4.543516105882939e-08 -0.08701363040658094 -0.8779000000000001 0.683772671478758 0.6837700859180513 -5.947466520162849e-08 -0.08701731933153885 -0.878 0.6837794130474143 0.6837768281384848 -7.350738305154578e-08 -0.0870210072813425 -0.8781 0.6837861526216751 0.683783568655878 -8.753028757878256e-08 -0.08702469425620837 -0.8782000000000001 0.6837928902021212 0.6837903074705507 -1.0154035438858511e-07 -0.0870283802563529 -0.8783000000000001 0.6837996257893656 0.6837970445827908 -1.1553456237198279e-07 -0.08703206528199255 -0.8784000000000001 0.6838063593840517 0.6838037799928551 -1.2950989435565885e-07 -0.08703574933334368 -0.8785 0.6838130909868545 0.6838105137009687 -1.4346333776678322e-07 -0.08703943241062266 -0.8786 0.6838198205984802 0.6838172457073259 -1.5739188525057402e-07 -0.08704311451404587 -0.8787 0.6838265482196659 0.683823976012089 -1.7129253535377864e-07 -0.08704679564382958 -0.8788 0.6838332738511799 0.6838307046153893 -1.8516229315784782e-07 -0.08705047580019007 -0.8789000000000001 0.6838399974938214 0.6838374315173275 -1.989981709277222e-07 -0.08705415498334362 -0.879 0.6838467191484208 0.6838441567179725 -2.1279718874153697e-07 -0.08705783319350649 -0.8791 0.6838534388158388 0.683850880217363 -2.2655637514981675e-07 -0.08706151043089494 -0.8792000000000001 0.6838601564969671 0.683857602015506 -2.4027276780344553e-07 -0.08706518669572509 -0.8793000000000001 0.6838668721927281 0.6838643221123786 -2.5394341410939214e-07 -0.08706886198821313 -0.8794000000000001 0.6838735859040745 0.6838710405079265 -2.675653718482718e-07 -0.08707253630857525 -0.8795 0.6838802976319898 0.6838777572020652 -2.8113570981619374e-07 -0.08707620965702755 -0.8796 0.683887007377487 0.68388447219468 -2.946515084492618e-07 -0.0870798820337861 -0.8797 0.6838937151416098 0.6838911854856251 -3.081098604792998e-07 -0.08708355343906694 -0.8798 0.683900420925432 0.6838978970747254 -3.215078715340658e-07 -0.0870872238730862 -0.8799000000000001 0.6839071247300572 0.6839046069617754 -3.348426607235888e-07 -0.0870908933360599 -0.88 0.6839138265566187 0.6839113151465395 -3.4811136134793585e-07 -0.08709456182820399 -0.8801 0.6839205264062791 0.6839180216287528 -3.6131112145232347e-07 -0.08709822934973448 -0.8802000000000001 0.6839272242802307 0.6839247264081207 -3.74439104465496e-07 -0.0871018959008673 -0.8803000000000001 0.6839339201796948 0.6839314294843188 -3.874924898172871e-07 -0.08710556148181833 -0.8804000000000001 0.6839406141059223 0.6839381308569941 -4.004684734590369e-07 -0.08710922609280357 -0.8805 0.6839473060601926 0.6839448305257639 -4.1336426861299236e-07 -0.0871128897340388 -0.8806 0.6839539960438138 0.6839515284902171 -4.261771062372133e-07 -0.08711655240573991 -0.8807 0.6839606840581229 0.6839582247499139 -4.3890423576109505e-07 -0.08712021410812278 -0.8808 0.6839673701044846 0.6839649193043853 -4.515429254808856e-07 -0.08712387484140306 -0.8809000000000001 0.6839740541842924 0.683971612153135 -4.6409046336459703e-07 -0.08712753460579666 -0.881 0.6839807362989672 0.6839783032956381 -4.7654415744752265e-07 -0.0871311934015193 -0.8811 0.683987416449958 0.6839849927313422 -4.889013365538819e-07 -0.08713485122878668 -0.8812000000000001 0.6839940946387411 0.6839916804596664 -5.011593507894818e-07 -0.08713850808781452 -0.8813000000000001 0.6840007708668202 0.6839983664800032 -5.133155721662175e-07 -0.08714216397881848 -0.8814000000000001 0.6840074451357259 0.6840050507917177 -5.253673950461613e-07 -0.08714581890201424 -0.8815 0.6840141174470155 0.6840117333941482 -5.373122368285133e-07 -0.08714947285761744 -0.8816 0.6840207878022728 0.6840184142866058 -5.491475385394073e-07 -0.08715312584584359 -0.8817 0.6840274562031083 0.6840250934683756 -5.608707651927336e-07 -0.08715677786690836 -0.8818 0.6840341226511587 0.6840317709387165 -5.724794065048444e-07 -0.08716042892102728 -0.8819000000000001 0.6840407871480856 0.6840384466968609 -5.839709773386437e-07 -0.08716407900841587 -0.882 0.6840474496955766 0.6840451207420163 -5.953430183280872e-07 -0.08716772812928962 -0.8821 0.684054110295345 0.6840517930733644 -6.065930963083943e-07 -0.08717137628386404 -0.8822000000000001 0.684060768949128 0.6840584636900617 -6.177188048850368e-07 -0.08717502347235455 -0.8823000000000001 0.6840674256586885 0.6840651325912399 -6.287177649749731e-07 -0.08717866969497653 -0.8824000000000001 0.6840740804258135 0.6840717997760066 -6.395876251674704e-07 -0.08718231495194552 -0.8825 0.684080733252314 0.6840784652434444 -6.50326062487383e-07 -0.0871859592434768 -0.8826 0.6840873841400248 0.6840851289926125 -6.609307826727084e-07 -0.08718960256978578 -0.8827 0.6840940330908039 0.6840917910225459 -6.713995207852097e-07 -0.08719324493108768 -0.8828 0.6841006801065332 0.6840984513322571 -6.817300416406269e-07 -0.0871968863275979 -0.8829000000000001 0.684107325189117 0.6841051099207346 -6.919201402666442e-07 -0.08720052675953167 -0.883 0.6841139683404823 0.684111766786945 -7.019676424857568e-07 -0.0872041662271043 -0.8831 0.6841206095625784 0.684118421929832 -7.118704051928271e-07 -0.08720780473053097 -0.8832000000000001 0.684127248857376 0.6841250753483171 -7.216263170628512e-07 -0.08721144227002685 -0.8833000000000001 0.6841338862268683 0.684131727041301 -7.312332987036152e-07 -0.08721507884580719 -0.8834000000000001 0.6841405216730689 0.6841383770076617 -7.406893033634621e-07 -0.0872187144580871 -0.8835 0.6841471551980132 0.684145025246257 -7.499923172643586e-07 -0.08722234910708175 -0.8836 0.6841537868037558 0.684151671755924 -7.591403600459845e-07 -0.0872259827930062 -0.8837 0.6841604164923727 0.6841583165354788 -7.681314850571663e-07 -0.0872296155160755 -0.8838 0.6841670442659592 0.6841649595837183 -7.769637800358886e-07 -0.08723324727650475 -0.8839000000000001 0.6841736701266303 0.6841716008994193 -7.856353672897054e-07 -0.087236878074509 -0.884 0.6841802940765201 0.6841782404813394 -7.941444041537071e-07 -0.08724050791030319 -0.8841 0.6841869161177814 0.6841848783282172 -8.02489083490121e-07 -0.08724413678410231 -0.8842000000000001 0.6841935362525853 0.6841915144387729 -8.10667633896478e-07 -0.08724776469612135 -0.8843000000000001 0.6842001544831211 0.6841981488117088 -8.186783202746017e-07 -0.08725139164657525 -0.8844000000000001 0.6842067708115954 0.6842047814457088 -8.265194441081647e-07 -0.08725501763567883 -0.8845 0.6842133852402323 0.6842114123394398 -8.341893436986103e-07 -0.08725864266364704 -0.8846 0.6842199977712728 0.6842180414915515 -8.41686394761898e-07 -0.08726226673069468 -0.8847 0.6842266084069744 0.6842246689006772 -8.490090105256476e-07 -0.08726588983703659 -0.8848 0.6842332171496104 0.6842312945654339 -8.56155642339762e-07 -0.08726951198288757 -0.8849000000000001 0.68423982400147 0.6842379184844225 -8.631247797180608e-07 -0.08727313316846246 -0.885 0.6842464289648573 0.684244540656229 -8.699149508517579e-07 -0.08727675339397589 -0.8851 0.6842530320420919 0.6842511610794239 -8.765247228870177e-07 -0.08728037265964267 -0.8852000000000001 0.6842596332355073 0.6842577797525631 -8.82952702188633e-07 -0.08728399096567743 -0.8853000000000001 0.6842662325474516 0.6842643966741888 -8.891975347563585e-07 -0.08728760831229494 -0.8854000000000001 0.6842728299802859 0.6842710118428288 -8.952579061693999e-07 -0.08729122469970978 -0.8855 0.6842794255363851 0.6842776252569979 -9.011325423913252e-07 -0.0872948401281366 -0.8856 0.6842860192181363 0.6842842369151978 -9.068202094647537e-07 -0.08729845459778995 -0.8857 0.6842926110279397 0.6842908468159177 -9.123197143440231e-07 -0.08730206810888451 -0.8858 0.6842992009682067 0.6842974549576346 -9.176299046592673e-07 -0.0873056806616347 -0.8859000000000001 0.6843057890413611 0.684304061338814 -9.227496692854054e-07 -0.08730929225625517 -0.886 0.6843123752498368 0.6843106659579101 -9.276779383698974e-07 -0.0873129028929603 -0.8861 0.684318959596079 0.6843172688133659 -9.324136836519337e-07 -0.0873165125719646 -0.8862000000000001 0.6843255420825431 0.6843238699036146 -9.369559187955012e-07 -0.08732012129348257 -0.8863000000000001 0.6843321227116941 0.6843304692270793 -9.413036992783619e-07 -0.08732372905772856 -0.8864000000000001 0.6843387014860065 0.6843370667821731 -9.454561229055303e-07 -0.08732733586491698 -0.8865 0.6843452784079638 0.6843436625673007 -9.49412329864785e-07 -0.08733094171526226 -0.8866 0.6843518534800572 0.6843502565808577 -9.531715028515686e-07 -0.08733454660897864 -0.8867 0.6843584267047874 0.6843568488212317 -9.567328673465436e-07 -0.08733815054628052 -0.8868 0.6843649980846616 0.6843634392868028 -9.600956917543702e-07 -0.08734175352738219 -0.8869000000000001 0.684371567622194 0.684370027975943 -9.632592875286061e-07 -0.08734535555249785 -0.887 0.6843781353199063 0.6843766148870185 -9.662230091994628e-07 -0.08734895662184183 -0.8871 0.684384701180326 0.6843832000183885 -9.689862548040162e-07 -0.08735255673562833 -0.8872000000000001 0.6843912652059861 0.6843897833684064 -9.715484657335516e-07 -0.08735615589407149 -0.8873000000000001 0.6843978273994255 0.68439636493542 -9.739091269139744e-07 -0.08735975409738553 -0.8874000000000001 0.6844043877631873 0.6844029447177719 -9.76067766958466e-07 -0.08736335134578449 -0.8875 0.68441094629982 0.6844095227138007 -9.780239583340178e-07 -0.08736694763948262 -0.8876000000000001 0.684417503011875 0.6844160989218406 -9.797773173475521e-07 -0.08737054297869393 -0.8877 0.684424057901908 0.6844226733402221 -9.813275041042901e-07 -0.08737413736363253 -0.8878 0.6844306109724774 0.6844292459672722 -9.82674222840818e-07 -0.08737773079451241 -0.8879000000000001 0.6844371622261441 0.6844358168013156 -9.838172217169205e-07 -0.08738132327154763 -0.888 0.6844437116654715 0.6844423858406745 -9.847562931764031e-07 -0.08738491479495213 -0.8881 0.6844502592930244 0.6844489530836695 -9.85491273503003e-07 -0.0873885053649399 -0.8882000000000001 0.6844568051113689 0.6844555185286192 -9.860220435142786e-07 -0.08739209498172489 -0.8883000000000001 0.6844633491230716 0.6844620821738421 -9.863485279371087e-07 -0.08739568364552097 -0.8884000000000001 0.6844698913306999 0.6844686440176556 -9.864706958795377e-07 -0.08739927135654205 -0.8885 0.684476431736821 0.6844752040583775 -9.86388560469953e-07 -0.08740285811500204 -0.8886000000000001 0.684482970344001 0.6844817622943256 -9.861021791068847e-07 -0.08740644392111467 -0.8887 0.6844895071548049 0.6844883187238194 -9.856116533479842e-07 -0.0874100287750938 -0.8888 0.6844960421717972 0.684494873345179 -9.849171288545122e-07 -0.08741361267715322 -0.8889000000000001 0.6845025753975389 0.684501426156727 -9.840187955023616e-07 -0.08741719562750669 -0.889 0.6845091068345894 0.6845079771567877 -9.829168869379679e-07 -0.08742077762636791 -0.8891 0.6845156364855054 0.6845145263436884 -9.816116812166875e-07 -0.0874243586739506 -0.8892 0.68452216435284 0.68452107371576 -9.801034999978864e-07 -0.08742793877046849 -0.8893000000000001 0.6845286904391418 0.6845276192713363 -9.78392708905762e-07 -0.08743151791613513 -0.8894000000000001 0.6845352147469561 0.6845341630087558 -9.764797172656658e-07 -0.08743509611116425 -0.8895 0.6845417372788232 0.6845407049263615 -9.743649781457364e-07 -0.08743867335576941 -0.8896000000000001 0.6845482580372777 0.6845472450225013 -9.720489881487326e-07 -0.08744224965016416 -0.8897 0.6845547770248492 0.6845537832955287 -9.695322873426448e-07 -0.08744582499456212 -0.8898 0.6845612942440606 0.6845603197438029 -9.668154590247724e-07 -0.08744939938917673 -0.8899000000000001 0.684567809697429 0.6845668543656896 -9.638991298743793e-07 -0.08745297283422154 -0.89 0.6845743233874637 0.6845733871595617 -9.607839693420717e-07 -0.08745654532991 -0.8901 0.6845808353166674 0.6845799181237988 -9.574706901355201e-07 -0.08746011687645557 -0.8902 0.6845873454875342 0.6845864472567887 -9.53960047359037e-07 -0.08746368747407168 -0.8903000000000001 0.6845938539025505 0.6845929745569271 -9.502528388605214e-07 -0.08746725712297175 -0.8904000000000001 0.684600360564193 0.6845995000226184 -9.463499049122692e-07 -0.0874708258233691 -0.8905 0.6846068654749302 0.684606023652276 -9.422521278223961e-07 -0.08747439357547708 -0.8906000000000001 0.6846133686372207 0.6846125454443229 -9.379604321013701e-07 -0.08747796037950907 -0.8907 0.6846198700535124 0.6846190653971919 -9.334757838652674e-07 -0.0874815262356783 -0.8908 0.6846263697262436 0.6846255835093262 -9.287991909190385e-07 -0.08748509114419806 -0.8909000000000001 0.6846328676578408 0.6846320997791795 -9.239317023818083e-07 -0.08748865510528156 -0.891 0.6846393638507197 0.6846386142052173 -9.188744085897316e-07 -0.08749221811914203 -0.8911 0.6846458583072841 0.6846451267859164 -9.13628440554759e-07 -0.08749578018599266 -0.8912 0.6846523510299256 0.6846516375197655 -9.081949701172931e-07 -0.08749934130604664 -0.8913000000000001 0.6846588420210231 0.6846581464052665 -9.025752094188322e-07 -0.08750290147951711 -0.8914000000000001 0.6846653312829423 0.6846646534409331 -8.967704106938035e-07 -0.08750646070661715 -0.8915 0.6846718188180357 0.6846711586252933 -8.907818659642519e-07 -0.08751001898755988 -0.8916000000000001 0.6846783046286418 0.6846776619568882 -8.84610906845551e-07 -0.08751357632255832 -0.8917 0.6846847887170847 0.6846841634342731 -8.782589041023137e-07 -0.08751713271182554 -0.8918 0.6846912710856741 0.6846906630560183 -8.717272675512477e-07 -0.08752068815557452 -0.8919000000000001 0.6846977517367039 0.6846971608207086 -8.650174455754334e-07 -0.08752424265401826 -0.892 0.6847042306724533 0.6847036567269442 -8.581309249161562e-07 -0.0875277962073697 -0.8921 0.6847107078951855 0.6847101507733413 -8.510692302843292e-07 -0.08753134881584175 -0.8922 0.684717183407147 0.684716642958532 -8.438339239025261e-07 -0.08753490047964738 -0.8923000000000001 0.6847236572105677 0.6847231332811647 -8.364266055049807e-07 -0.08753845119899939 -0.8924000000000001 0.6847301293076609 0.6847296217399055 -8.28848911588187e-07 -0.08754200097411069 -0.8925 0.6847365997006218 0.6847361083334369 -8.21102515452532e-07 -0.08754554980519408 -0.8926000000000001 0.6847430683916282 0.6847425930604594 -8.131891263835067e-07 -0.08754909769246234 -0.8927 0.68474953538284 0.6847490759196918 -8.051104896100725e-07 -0.0875526446361283 -0.8928 0.6847560006763977 0.6847555569098709 -7.968683858605718e-07 -0.08755619063640466 -0.8929000000000001 0.6847624642744236 0.6847620360297524 -7.884646308908838e-07 -0.08755973569350416 -0.893 0.6847689261790202 0.6847685132781112 -7.799010751652347e-07 -0.08756327980763946 -0.8931 0.6847753863922706 0.6847749886537418 -7.711796032872087e-07 -0.08756682297902328 -0.8932 0.6847818449162382 0.6847814621554582 -7.623021338470926e-07 -0.08757036520786823 -0.8933000000000001 0.6847883017529655 0.684787933782095 -7.532706188667637e-07 -0.08757390649438695 -0.8934000000000001 0.6847947569044748 0.6847944035325071 -7.440870433278457e-07 -0.08757744683879208 -0.8935 0.6848012103727666 0.6848008714055702 -7.347534247276188e-07 -0.08758098624129605 -0.8936000000000001 0.684807662159821 0.6848073374001812 -7.252718128153424e-07 -0.08758452470211145 -0.8937 0.6848141122675961 0.6848138015152592 -7.156442888844872e-07 -0.08758806222145091 -0.8938 0.6848205606980275 0.6848202637497441 -7.058729655229357e-07 -0.08759159879952678 -0.8939000000000001 0.6848270074530289 0.6848267241025987 -6.959599860995036e-07 -0.08759513443655155 -0.894 0.6848334525344912 0.684833182572808 -6.859075242088286e-07 -0.08759866913273767 -0.8941 0.6848398959442823 0.6848396391593801 -6.757177833383032e-07 -0.08760220288829754 -0.8942 0.6848463376842469 0.6848460938613461 -6.653929962574523e-07 -0.08760573570344352 -0.8943000000000001 0.6848527777562061 0.6848525466777602 -6.549354245183325e-07 -0.08760926757838798 -0.8944000000000001 0.6848592161619573 0.6848589976077011 -6.443473581363435e-07 -0.0876127985133433 -0.8945 0.6848656529032736 0.6848654466502705 -6.336311149518492e-07 -0.08761632850852175 -0.8946000000000001 0.6848720879819035 0.6848718938045951 -6.227890401028224e-07 -0.08761985756413558 -0.8947 0.6848785213995706 0.684878339069826 -6.118235056223886e-07 -0.08762338568039703 -0.8948 0.684884953157974 0.684884782445139 -6.0073690978657e-07 -0.08762691285751834 -0.8949000000000001 0.6848913832587875 0.6848912239297351 -5.895316767118297e-07 -0.08763043909571173 -0.895 0.684897811703659 0.6848976635228409 -5.782102557860824e-07 -0.08763396439518935 -0.8951 0.6849042384942107 0.6849041012237083 -5.667751210580718e-07 -0.08763748875616333 -0.8952 0.684910663632039 0.6849105370316153 -5.552287708210368e-07 -0.08764101217884585 -0.8953000000000001 0.6849170871187137 0.6849169709458661 -5.435737269743335e-07 -0.08764453466344893 -0.8954000000000001 0.6849235089557781 0.6849234029657909 -5.318125345377123e-07 -0.08764805621018462 -0.8955 0.6849299291447492 0.684929833090747 -5.199477610406955e-07 -0.08765157681926507 -0.8956000000000001 0.6849363476871162 0.6849362613201184 -5.079819960368548e-07 -0.08765509649090222 -0.8957 0.6849427645843418 0.684942687653316 -4.959178504168604e-07 -0.08765861522530805 -0.8958 0.6849491798378606 0.6849491120897782 -4.837579559990868e-07 -0.08766213302269453 -0.8959000000000001 0.6849555934490801 0.6849555346289706 -4.715049648565395e-07 -0.08766564988327359 -0.896 0.6849620054193799 0.6849619552703867 -4.5916154869929393e-07 -0.08766916580725717 -0.8961 0.684968415750111 0.684968374013548 -4.467303984026505e-07 -0.08767268079485713 -0.8962 0.6849748244425968 0.684974790858004 -4.342142233479396e-07 -0.0876761948462853 -0.8963000000000001 0.6849812314981321 0.6849812058033327 -4.216157508535323e-07 -0.08767970796175359 -0.8964000000000001 0.6849876369179826 0.6849876188491398 -4.089377255919735e-07 -0.0876832201414737 -0.8965 0.6849940407033858 0.6849940299950606 -3.9618290893078667e-07 -0.08768673138565747 -0.8966000000000001 0.6850004428555498 0.6850004392407587 -3.833540784398126e-07 -0.08769024169451663 -0.8967 0.6850068433756539 0.6850068465859268 -3.704540272042589e-07 -0.08769375106826288 -0.8968 0.6850132422648476 0.6850132520302865 -3.574855632418328e-07 -0.08769725950710791 -0.8969000000000001 0.6850196395242517 0.685019655573589 -3.4445150886436293e-07 -0.08770076701126339 -0.897 0.6850260351549569 0.685026057215615 -3.3135470015044355e-07 -0.08770427358094102 -0.8971 0.6850324291580242 0.6850324569561743 -3.1819798623072826e-07 -0.08770777921635235 -0.8972 0.6850388215344851 0.6850388547951072 -3.049842287189408e-07 -0.08771128391770902 -0.8973000000000001 0.685045212285341 0.6850452507322826 -2.917163010734969e-07 -0.08771478768522258 -0.8974000000000001 0.6850516014115628 0.6850516447676005 -2.7839708797300355e-07 -0.08771829051910454 -0.8975 0.6850579889140915 0.6850580369009901 -2.6502948468135057e-07 -0.0877217924195664 -0.8976000000000001 0.6850643747938379 0.6850644271324113 -2.516163964613738e-07 -0.08772529338681967 -0.8977 0.6850707590516825 0.6850708154618541 -2.381607379017825e-07 -0.08772879342107581 -0.8978 0.6850771416884751 0.685077201889339 -2.2466543228918945e-07 -0.08773229252254632 -0.8979000000000001 0.6850835227050345 0.6850835864149163 -2.111334109836105e-07 -0.08773579069144244 -0.898 0.6850899021021495 0.6850899690386676 -1.9756761277661683e-07 -0.0877392879279757 -0.8981 0.6850962798805782 0.6850963497607045 -1.839709832668346e-07 -0.08774278423235739 -0.8982 0.6851026560410469 0.6851027285811697 -1.7034647419034155e-07 -0.0877462796047988 -0.8983000000000001 0.6851090305842524 0.6851091055002361 -1.5669704280657504e-07 -0.08774977404551129 -0.8984000000000001 0.68511540351086 0.6851154805181078 -1.4302565126168842e-07 -0.08775326755470611 -0.8985 0.6851217748215034 0.6851218536350194 -1.2933526591721312e-07 -0.08775676013259448 -0.8986000000000001 0.6851281445167863 0.6851282248512365 -1.1562885672208867e-07 -0.08776025177938762 -0.8987 0.685134512597281 0.6851345941670552 -1.0190939657948872e-07 -0.08776374249529673 -0.8988 0.6851408790635287 0.6851409615828035 -8.817986067721773e-08 -0.087767232280533 -0.8989000000000001 0.6851472439160395 0.685147327098839 -7.44432258588737e-08 -0.08777072113530754 -0.899 0.6851536071552926 0.6851536907155509 -6.070246998200052e-08 -0.08777420905983147 -0.8991 0.6851599687817362 0.6851600524333594 -4.696057126583192e-08 -0.08777769605431586 -0.8992 0.6851663287957868 0.6851664122527155 -3.322050764120385e-08 -0.08778118211897178 -0.8993000000000001 0.6851726871978305 0.685172770174101 -1.948525611456149e-08 -0.08778466725401028 -0.8994000000000001 0.6851790439882219 0.6851791261980287 -5.75779211461902e-09 -0.08778815145964226 -0.8995 0.6851853991672852 0.6851854803250422 7.958911146452308e-09 -0.08779163473607882 -0.8996000000000001 0.6851917527353126 0.6851918325557163 2.1661883315739205e-08 -0.08779511708353087 -0.8997 0.6851981046925665 0.6851981828906559 3.534815755899812e-08 -0.08779859850220932 -0.8998 0.6852044550392772 0.6852045313304976 4.901477117583153e-08 -0.08780207899232507 -0.8999000000000001 0.685210803775645 0.6852108778759081 6.265876627102596e-08 -0.08780555855408902 -0.9 0.685217150901839 0.6852172225275844 7.62771903608378e-08 -0.08780903718771194 -0.9001 0.6852234964179977 0.6852235652862553 8.986709704519869e-08 -0.08781251489340475 -0.9002 0.6852298403242285 0.6852299061526791 1.0342554662701176e-07 -0.08781599167137813 -0.9003000000000001 0.6852361826206087 0.6852362451276447 1.1694960676614241e-07 -0.08781946752184289 -0.9004000000000001 0.685242523307185 0.685242582211972 1.3043635308310209e-07 -0.08782294244500984 -0.9005 0.6852488623839732 0.6852489174065105 1.4388286982344733e-07 -0.08782641644108954 -0.9006000000000001 0.6852551998509594 0.6852552507121403 1.5728625045105527e-07 -0.0878298895102928 -0.9007000000000001 0.6852615357080988 0.6852615821297714 1.7064359832119624e-07 -0.0878333616528302 -0.9008 0.6852678699553169 0.6852679116603437 1.8395202728421767e-07 -0.08783683286891242 -0.9009000000000001 0.6852742025925087 0.6852742393048272 1.9720866231351386e-07 -0.08784030315874998 -0.901 0.6852805336195402 0.6852805650642217 2.1041064011961819e-07 -0.08784377252255356 -0.9011 0.6852868630362468 0.6852868889395567 2.2355510977123405e-07 -0.08784724096053367 -0.9012 0.6852931908424345 0.6852932109318903 2.3663923332667425e-07 -0.0878507084729008 -0.9013000000000001 0.6852995170378795 0.6852995310423109 2.496601864340753e-07 -0.0878541750598654 -0.9014000000000001 0.6853058416223294 0.6853058492719362 2.626151589246728e-07 -0.08785764072163806 -0.9015 0.685312164595502 0.685312165621912 2.755013554581187e-07 -0.08786110545842912 -0.9016000000000001 0.6853184859570862 0.6853184800934138 2.8831599607065383e-07 -0.08786456927044904 -0.9017000000000001 0.6853248057067421 0.6853247926876455 3.0105631687593615e-07 -0.08786803215790823 -0.9018 0.6853311238441011 0.6853311034058396 3.137195705160689e-07 -0.08787149412101698 -0.9019000000000001 0.6853374403687658 0.6853374122492571 3.2630302689712343e-07 -0.08787495515998567 -0.902 0.6853437552803106 0.685343719219187 3.3880397372343385e-07 -0.08787841527502457 -0.9021 0.6853500685782818 0.6853500243169464 3.5121971701801424e-07 -0.087881874466344 -0.9022 0.685356380262198 0.6853563275438801 3.635475818025702e-07 -0.08788533273415419 -0.9023000000000001 0.6853626903315497 0.6853626289013606 3.757849126317936e-07 -0.08788879007866536 -0.9024000000000001 0.6853689987857997 0.6853689283907876 3.879290741484742e-07 -0.08789224650008769 -0.9025 0.6853753056243842 0.6853752260135881 3.9997745168718346e-07 -0.08789570199863136 -0.9026000000000001 0.6853816108467112 0.6853815217712164 4.119274518571414e-07 -0.08789915657450653 -0.9027000000000001 0.6853879144521631 0.6853878156651528 4.237765029724283e-07 -0.08790261022792333 -0.9028 0.6853942164400946 0.6853941076969049 4.3552205578056835e-07 -0.08790606295909183 -0.9029 0.6854005168098343 0.6854003978680059 4.4716158394131345e-07 -0.08790951476822206 -0.903 0.6854068155606848 0.6854066861800152 4.586925844429768e-07 -0.0879129656555241 -0.9031 0.6854131126919227 0.6854129726345184 4.701125784351001e-07 -0.08791641562120797 -0.9032 0.6854194082027986 0.6854192572331259 4.814191114366206e-07 -0.08791986466548357 -0.9033000000000001 0.6854257020925384 0.6854255399774736 4.92609754113027e-07 -0.08792331278856091 -0.9034000000000001 0.6854319943603423 0.6854318208692226 5.036821026510596e-07 -0.08792675999064992 -0.9035 0.6854382850053857 0.6854380999100588 5.146337793277e-07 -0.08793020627196046 -0.9036000000000001 0.6854445740268198 0.685444377101692 5.254624329958935e-07 -0.08793365163270246 -0.9037000000000001 0.6854508614237707 0.6854506524458568 5.361657397090491e-07 -0.08793709607308572 -0.9038 0.6854571471953412 0.6854569259443111 5.467414030679851e-07 -0.0879405395933201 -0.9039 0.6854634313406102 0.6854631975988367 5.571871546650176e-07 -0.08794398219361532 -0.904 0.6854697138586328 0.6854694674112387 5.675007548888722e-07 -0.08794742387418121 -0.9041 0.6854759947484415 0.6854757353833452 5.776799930357068e-07 -0.08795086463522747 -0.9042 0.6854822740090456 0.6854820015170064 5.877226880307562e-07 -0.08795430447696384 -0.9043000000000001 0.685488551639432 0.6854882658140955 5.976266887197657e-07 -0.08795774339959996 -0.9044000000000001 0.6854948276385653 0.6854945282765077 6.073898745628803e-07 -0.08796118140334547 -0.9045 0.6855011020053885 0.6855007889061597 6.17010155842812e-07 -0.08796461848841007 -0.9046000000000001 0.6855073747388228 0.6855070477049897 6.264854742060733e-07 -0.0879680546550033 -0.9047000000000001 0.6855136458377682 0.685513304674957 6.358138031348215e-07 -0.08797148990333475 -0.9048 0.6855199153011039 0.6855195598180414 6.449931483493154e-07 -0.08797492423361397 -0.9049 0.6855261831276885 0.6855258131362432 6.540215483769041e-07 -0.08797835764605047 -0.905 0.6855324493163604 0.6855320646315832 6.628970746630491e-07 -0.08798179014085375 -0.9051 0.6855387138659381 0.6855383143061011 6.716178323207256e-07 -0.08798522171823327 -0.9052 0.6855449767752211 0.6855445621618568 6.80181960296955e-07 -0.08798865237839851 -0.9053000000000001 0.6855512380429887 0.6855508082009283 6.885876318862838e-07 -0.08799208212155882 -0.9054000000000001 0.6855574976680023 0.6855570524254126 6.968330550499724e-07 -0.08799551094792357 -0.9055 0.6855637556490046 0.6855632948374253 7.049164728323287e-07 -0.08799893885770216 -0.9056000000000001 0.6855700119847203 0.6855695354390996 7.128361638741865e-07 -0.0880023658511039 -0.9057000000000001 0.6855762666738563 0.6855757742325859 7.205904424267828e-07 -0.08800579192833805 -0.9058 0.6855825197151022 0.6855820112200521 7.281776591011591e-07 -0.0880092170896139 -0.9059 0.685588771107131 0.6855882464036832 7.355962010902051e-07 -0.08801264133514075 -0.906 0.685595020848599 0.6855944797856802 7.428444923213151e-07 -0.0880160646651278 -0.9061 0.6856012689381459 0.6856007113682597 7.499209941502771e-07 -0.08801948707978416 -0.9062 0.6856075153743961 0.6856069411536545 7.568242052780061e-07 -0.08802290857931906 -0.9063000000000001 0.6856137601559588 0.6856131691441127 7.635526623611666e-07 -0.08802632916394167 -0.9064000000000001 0.6856200032814277 0.6856193953418968 7.701049402619731e-07 -0.08802974883386101 -0.9065 0.6856262447493826 0.6856256197492836 7.764796523257456e-07 -0.08803316758928625 -0.9066000000000001 0.6856324845583885 0.6856318423685643 7.826754507000988e-07 -0.08803658543042642 -0.9067000000000001 0.6856387227069971 0.6856380632020438 7.886910265431091e-07 -0.08804000235749056 -0.9068 0.6856449591937465 0.6856442822520391 7.945251104118922e-07 -0.08804341837068758 -0.9069 0.6856511940171619 0.6856504995208814 8.001764724846483e-07 -0.08804683347022652 -0.907 0.6856574271757556 0.6856567150109139 8.056439227827061e-07 -0.0880502476563163 -0.9071 0.6856636586680287 0.6856629287244909 8.109263114203236e-07 -0.0880536609291658 -0.9072 0.6856698884924701 0.685669140663979 8.160225290348988e-07 -0.08805707328898399 -0.9073000000000001 0.6856761166475575 0.6856753508317557 8.209315067175815e-07 -0.08806048473597967 -0.9074000000000001 0.6856823431317575 0.6856815592302097 8.256522164018509e-07 -0.08806389527036174 -0.9075 0.6856885679435267 0.6856877658617387 8.301836711688271e-07 -0.08806730489233894 -0.9076000000000001 0.6856947910813118 0.6856939707287515 8.345249252472708e-07 -0.08807071360212007 -0.9077000000000001 0.6857010125435492 0.6857001738336657 8.386750743466509e-07 -0.08807412139991388 -0.9078 0.6857072323286668 0.6857063751789079 8.426332559485772e-07 -0.08807752828592912 -0.9079 0.6857134504350841 0.685712574766913 8.463986491402675e-07 -0.08808093426037447 -0.908 0.6857196668612118 0.6857187726001246 8.499704751974146e-07 -0.08808433932345858 -0.9081 0.6857258816054526 0.6857249686809932 8.533479974315306e-07 -0.08808774347539008 -0.9082 0.6857320946662027 0.6857311630119769 8.565305214952579e-07 -0.0880911467163776 -0.9083000000000001 0.6857383060418509 0.6857373555955406 8.595173954933921e-07 -0.08809454904662978 -0.9084000000000001 0.6857445157307794 0.6857435464341555 8.623080101355374e-07 -0.08809795046635509 -0.9085 0.6857507237313646 0.6857497355302984 8.649017988471286e-07 -0.0881013509757621 -0.9086000000000001 0.6857569300419772 0.6857559228864519 8.672982378804539e-07 -0.08810475057505934 -0.9087000000000001 0.6857631346609828 0.6857621085051033 8.694968464117991e-07 -0.08810814926445525 -0.9088 0.6857693375867422 0.6857682923887448 8.714971866663479e-07 -0.08811154704415827 -0.9089 0.6857755388176121 0.6857744745398722 8.732988640153261e-07 -0.08811494391437685 -0.909 0.6857817383519456 0.6857806549609848 8.749015269760019e-07 -0.08811833987531936 -0.9091 0.6857879361880922 0.685786833654586 8.763048673365859e-07 -0.08812173492719422 -0.9092 0.6857941323243983 0.6857930106231811 8.775086202394977e-07 -0.08812512907020967 -0.9093000000000001 0.6858003267592084 0.6857991858692778 8.785125642923886e-07 -0.08812852230457409 -0.9094000000000001 0.6858065194908647 0.6858053593953859 8.793165214016074e-07 -0.08813191463049573 -0.9095 0.6858127105177079 0.6858115312040161 8.799203569387348e-07 -0.08813530604818283 -0.9096000000000001 0.6858188998380776 0.6858177012976807 8.803239797683382e-07 -0.08813869655784366 -0.9097000000000001 0.6858250874503129 0.6858238696788921 8.80527342247972e-07 -0.08814208615968638 -0.9098 0.6858312733527527 0.6858300363501624 8.805304403253222e-07 -0.08814547485391921 -0.9099 0.6858374575437363 0.6858362013140038 8.80333313232895e-07 -0.08814886264075028 -0.91 0.6858436400216033 0.6858423645729272 8.799360437655723e-07 -0.08815224952038768 -0.9101 0.6858498207846949 0.6858485261294426 8.7933875829449e-07 -0.08815563549303951 -0.9102 0.6858559998313538 0.6858546859860577 8.785416263923373e-07 -0.08815902055891382 -0.9103000000000001 0.685862177159925 0.685860844145278 8.775448610415237e-07 -0.08816240471821866 -0.9104000000000001 0.6858683527687557 0.685867000609607 8.76348718634179e-07 -0.08816578797116204 -0.9105 0.6858745266561963 0.685873155381544 8.74953498777864e-07 -0.08816917031795196 -0.9106000000000001 0.6858806988206007 0.6858793084635855 8.733595441429154e-07 -0.08817255175879629 -0.9107000000000001 0.6858868692603264 0.6858854598582232 8.715672407538788e-07 -0.088175932293903 -0.9108 0.6858930379737355 0.6858916095679453 8.695770172817419e-07 -0.08817931192347997 -0.9109 0.685899204959195 0.6858977575952341 8.673893455990456e-07 -0.0881826906477351 -0.911 0.685905370215077 0.685903903942567 8.650047402664063e-07 -0.08818606846687621 -0.9111 0.685911533739759 0.6859100486124154 8.6242375850476e-07 -0.08818944538111105 -0.9112 0.6859176955316251 0.6859161916072445 8.596470000982182e-07 -0.08819282139064745 -0.9113000000000001 0.6859238555890659 0.685922332929513 8.56675107269167e-07 -0.08819619649569321 -0.9114000000000001 0.6859300139104788 0.6859284725816719 8.535087644284678e-07 -0.08819957069645604 -0.9115 0.6859361704942687 0.6859346105661647 8.501486982032125e-07 -0.08820294399314359 -0.9116000000000001 0.6859423253388484 0.6859407468854275 8.465956770342675e-07 -0.08820631638596356 -0.9117000000000001 0.6859484784426388 0.685946881541887 8.428505113011742e-07 -0.08820968787512358 -0.9118 0.6859546298040704 0.6859530145379613 8.389140527947925e-07 -0.08821305846083127 -0.9119 0.6859607794215818 0.6859591458760599 8.347871948422014e-07 -0.08821642814329424 -0.912 0.6859669272936221 0.6859652755585817 8.304708718070986e-07 -0.08821979692272007 -0.9121 0.6859730734186497 0.6859714035879153 8.259660591869444e-07 -0.08822316479931624 -0.9122 0.685979217795134 0.6859775299664391 8.212737731688735e-07 -0.08822653177329029 -0.9123000000000001 0.685985360421555 0.6859836546965203 8.163950704909162e-07 -0.08822989784484962 -0.9124000000000001 0.6859915012964042 0.6859897777805147 8.113310482615876e-07 -0.08823326301420176 -0.9125 0.6859976404181847 0.6859958992207662 8.06082843612943e-07 -0.08823662728155407 -0.9126000000000001 0.6860037777854118 0.6860020190196063 8.006516333397551e-07 -0.08823999064711402 -0.9127000000000001 0.6860099133966134 0.6860081371793538 7.950386339689031e-07 -0.08824335311108888 -0.9128000000000001 0.6860160472503304 0.6860142537023146 7.892451011903834e-07 -0.08824671467368606 -0.9129 0.6860221793451171 0.6860203685907809 7.832723296768984e-07 -0.08825007533511287 -0.913 0.6860283096795414 0.6860264818470305 7.771216528340563e-07 -0.08825343509557654 -0.9131 0.6860344382521857 0.6860325934733277 7.707944425228153e-07 -0.08825679395528435 -0.9132 0.6860405650616465 0.6860387034719215 7.642921086986609e-07 -0.08826015191444356 -0.9133000000000001 0.6860466901065354 0.686044811845046 7.576160990230285e-07 -0.0882635089732613 -0.9134000000000001 0.6860528133854797 0.6860509185949195 7.507678986967692e-07 -0.08826686513194473 -0.9135 0.6860589348971222 0.6860570237237448 7.437490300438165e-07 -0.08827022039070107 -0.9136 0.6860650546401222 0.6860631272337083 7.365610521642418e-07 -0.0882735747497374 -0.9137000000000001 0.6860711726131548 0.6860692291269794 7.292055606428205e-07 -0.08827692820926075 -0.9138000000000001 0.6860772888149124 0.6860753294057107 7.216841871882096e-07 -0.08828028076947822 -0.9139 0.6860834032441048 0.6860814280720375 7.139985991472253e-07 -0.08828363243059685 -0.914 0.6860895158994592 0.6860875251280771 7.061504994215761e-07 -0.0882869831928236 -0.9141 0.6860956267797211 0.6860936205759287 6.981416257739737e-07 -0.0882903330563655 -0.9142 0.6861017358836541 0.6860997144176731 6.899737505783321e-07 -0.08829368202142945 -0.9143000000000001 0.6861078432100403 0.686105806655372 6.816486805838462e-07 -0.08829703008822237 -0.9144000000000001 0.6861139487576813 0.6861118972910678 6.731682561933461e-07 -0.08830037725695113 -0.9145 0.6861200525253983 0.6861179863267838 6.645343513245194e-07 -0.08830372352782265 -0.9146 0.6861261545120318 0.6861240737645229 6.557488729103111e-07 -0.08830706890104373 -0.9147000000000001 0.6861322547164425 0.6861301596062681 6.468137604132007e-07 -0.08831041337682118 -0.9148000000000001 0.6861383531375116 0.6861362438539815 6.377309854782576e-07 -0.0883137569553618 -0.9149 0.6861444497741411 0.6861423265096043 6.285025515168075e-07 -0.0883170996368723 -0.915 0.6861505446252539 0.6861484075750566 6.19130493206832e-07 -0.08832044142155938 -0.9151 0.6861566376897948 0.6861544870522366 6.096168760350018e-07 -0.08832378230962977 -0.9152 0.6861627289667299 0.6861605649430209 5.999637958942206e-07 -0.08832712230129011 -0.9153000000000001 0.6861688184550474 0.686166641249264 5.901733786534136e-07 -0.08833046139674704 -0.9154000000000001 0.6861749061537581 0.6861727159727977 5.80247779560783e-07 -0.08833379959620719 -0.9155 0.6861809920618953 0.6861787891154307 5.701891829107408e-07 -0.0883371368998771 -0.9156 0.6861870761785156 0.6861848606789491 5.599998014471641e-07 -0.08834047330796337 -0.9157000000000001 0.6861931585026977 0.6861909306651154 5.496818759470612e-07 -0.08834380882067243 -0.9158000000000001 0.6861992390335454 0.6861969990756681 5.392376747903604e-07 -0.08834714343821087 -0.9159 0.6862053177701855 0.686203065912322 5.286694933492875e-07 -0.08835047716078512 -0.916 0.6862113947117687 0.6862091311767677 5.179796534054981e-07 -0.08835380998860157 -0.9161 0.6862174698574708 0.6862151948706712 5.07170502914156e-07 -0.08835714192186672 -0.9162 0.6862235432064916 0.6862212569956734 4.962444152267764e-07 -0.08836047296078686 -0.9163000000000001 0.6862296147580562 0.6862273175533906 4.852037887442817e-07 -0.08836380310556843 -0.9164000000000001 0.6862356845114147 0.6862333765454138 4.740510463063785e-07 -0.08836713235641772 -0.9165 0.6862417524658424 0.6862394339733078 4.6278863462256847e-07 -0.088370460713541 -0.9166 0.6862478186206409 0.6862454898386124 4.5141902388357025e-07 -0.0883737881771446 -0.9167000000000001 0.6862538829751367 0.6862515441428407 4.3994470706743005e-07 -0.0883771147474347 -0.9168000000000001 0.6862599455286833 0.6862575968874799 4.2836819952318805e-07 -0.08838044042461754 -0.9169 0.6862660062806601 0.6862636480739903 4.166920382700501e-07 -0.08838376520889925 -0.917 0.6862720652304732 0.686269697703806 4.049187815532984e-07 -0.08838708910048604 -0.9171 0.6862781223775556 0.686275745778334 3.930510082544858e-07 -0.08839041209958404 -0.9172 0.6862841777213673 0.6862817922989535 3.8109131735714064e-07 -0.08839373420639929 -0.9173000000000001 0.6862902312613955 0.6862878372670176 3.690423272945109e-07 -0.08839705542113799 -0.9174000000000001 0.6862962829971543 0.6862938806838503 3.569066754638417e-07 -0.08840037574400604 -0.9175 0.6863023329281859 0.6862999225507492 3.4468701764350795e-07 -0.08840369517520946 -0.9176 0.6863083810540604 0.6863059628689834 3.3238602732688083e-07 -0.08840701371495435 -0.9177000000000001 0.6863144273743756 0.6863120016397934 3.200063952296661e-07 -0.08841033136344657 -0.9178000000000001 0.6863204718887574 0.6863180388643924 3.0755082866540384e-07 -0.08841364812089209 -0.9179 0.6863265145968604 0.6863240745439643 2.9502205098341783e-07 -0.0884169639874968 -0.918 0.6863325554983671 0.6863301086796647 2.824228009096208e-07 -0.08842027896346655 -0.9181 0.686338594592989 0.6863361412726205 2.6975583201221953e-07 -0.08842359304900715 -0.9182 0.6863446318804661 0.6863421723239297 2.5702391206333663e-07 -0.08842690624432453 -0.9183000000000001 0.6863506673605677 0.6863482018346609 2.4422982244226565e-07 -0.0884302185496244 -0.9184000000000001 0.686356701033092 0.686354229805854 2.313763575595429e-07 -0.08843352996511256 -0.9185 0.6863627328978659 0.6863602562385188 2.1846632419775247e-07 -0.08843684049099462 -0.9186 0.6863687629547461 0.6863662811336364 2.0550254091478148e-07 -0.0884401501274764 -0.9187000000000001 0.686374791203619 0.6863723044921582 1.924878374331973e-07 -0.08844345887476356 -0.9188000000000001 0.6863808176444 0.6863783263150057 1.7942505404003328e-07 -0.08844676673306173 -0.9189 0.6863868422770341 0.6863843466030706 1.6631704096228828e-07 -0.08845007370257653 -0.919 0.6863928651014963 0.6863903653572145 1.5316665773895677e-07 -0.08845337978351352 -0.9191 0.6863988861177914 0.6863963825782695 1.3997677254795615e-07 -0.08845668497607827 -0.9192 0.6864049053259542 0.6864023982670373 1.26750261664893e-07 -0.08845998928047633 -0.9193000000000001 0.6864109227260491 0.6864084124242897 1.1349000879345983e-07 -0.08846329269691314 -0.9194000000000001 0.6864169383181711 0.6864144250507682 1.0019890442705681e-07 -0.08846659522559426 -0.9195 0.6864229521024449 0.6864204361471837 8.687984525204695e-08 -0.08846989686672509 -0.9196 0.6864289640790254 0.6864264457142173 7.353573348856113e-08 -0.08847319762051106 -0.9197000000000001 0.6864349742480982 0.6864324537525192 6.016947625905877e-08 -0.08847649748715754 -0.9198000000000001 0.6864409826098785 0.6864384602627092 4.6783984977705195e-08 -0.08847979646686989 -0.9199 0.6864469891646128 0.6864444652453772 3.338217469638083e-08 -0.08848309455985348 -0.92 0.6864529939125766 0.686450468701082 1.9966963473241894e-08 -0.08848639176631358 -0.9201 0.6864589968540769 0.6864564706303521 6.541271733474796e-09 -0.08848968808645546 -0.9202 0.6864649979894504 0.6864624710336854 -6.891978348265437e-09 -0.08849298352048436 -0.9203000000000001 0.6864709973190648 0.6864684699115493 -2.032986350141222e-08 -0.08849627806860551 -0.9204000000000001 0.6864769948433178 0.6864744672643802 -3.3769459989625716e-08 -0.08849957173102409 -0.9205 0.6864829905626377 0.6864804630925846 -4.7207844250634744e-08 -0.08850286450794526 -0.9206 0.6864889844774833 0.6864864573965381 -6.064209352599562e-08 -0.08850615639957418 -0.9207000000000001 0.6864949765883435 0.6864924501765856 -7.406928650153036e-08 -0.08850944740611591 -0.9208000000000001 0.6865009668957376 0.6864984414330417 -8.74865039406092e-08 -0.08851273752777553 -0.9209 0.6865069554002154 0.6865044311661905 -1.00890829324643e-07 -0.08851602676475807 -0.921 0.6865129421023572 0.6865104193762855 -1.1427934946961482e-07 -0.08851931511726861 -0.9211 0.6865189270027734 0.6865164060635498 -1.2764915519221376e-07 -0.08852260258551208 -0.9212 0.6865249101021043 0.6865223912281762 -1.4099734189747248e-07 -0.08852588916969346 -0.9213000000000001 0.6865308914010209 0.6865283748703271 -1.5432101026745249e-07 -0.08852917487001771 -0.9214000000000001 0.6865368709002238 0.6865343569901347 -1.676172668180903e-07 -0.08853245968668969 -0.9215 0.6865428486004443 0.6865403375877007 -1.8088322461043416e-07 -0.08853574361991429 -0.9216 0.6865488245024429 0.6865463166630974 -1.9411600379881655e-07 -0.08853902666989634 -0.9217000000000001 0.6865547986070105 0.686552294216366 -2.0731273232127423e-07 -0.08854230883684067 -0.9218000000000001 0.6865607709149677 0.6865582702475188 -2.2047054646506803e-07 -0.08854559012095208 -0.9219 0.6865667414271648 0.6865642447565374 -2.3358659155189865e-07 -0.08854887052243529 -0.922 0.6865727101444813 0.6865702177433746 -2.466580225034265e-07 -0.08855215004149504 -0.9221 0.6865786770678268 0.6865761892079522 -2.596820045039361e-07 -0.08855542867833605 -0.9222 0.6865846421981404 0.6865821591501635 -2.726557135485086e-07 -0.08855870643316299 -0.9223000000000001 0.68659060553639 0.686588127569872 -2.8557633712997244e-07 -0.08856198330618051 -0.9224000000000001 0.6865965670835725 0.6865940944669119 -2.9844107482523974e-07 -0.08856525929759321 -0.9225 0.6866025268407145 0.6866000598410884 -3.1124713885388733e-07 -0.0885685344076057 -0.9226 0.6866084848088707 0.6866060236921776 -3.2399175475816833e-07 -0.0885718086364225 -0.9227000000000001 0.6866144409891253 0.6866119860199261 -3.366721619754709e-07 -0.08857508198424813 -0.9228000000000001 0.6866203953825905 0.6866179468240527 -3.492856144177159e-07 -0.08857835445128713 -0.9229 0.6866263479904073 0.6866239061042472 -3.6182938110279617e-07 -0.08858162603774397 -0.923 0.6866322988137447 0.6866298638601709 -3.743007466749937e-07 -0.08858489674382307 -0.9231 0.6866382478537998 0.6866358200914571 -3.866970120849911e-07 -0.08858816656972887 -0.9232 0.6866441951117979 0.6866417747977105 -3.9901549513804424e-07 -0.0885914355156657 -0.9233000000000001 0.6866501405889918 0.6866477279785085 -4.1125353101439943e-07 -0.08859470358183796 -0.9234000000000001 0.6866560842866618 0.6866536796334006 -4.2340847295624373e-07 -0.08859797076845001 -0.9235 0.6866620262061158 0.686659629761909 -4.354776927742443e-07 -0.08860123707570611 -0.9236 0.6866679663486888 0.6866655783635276 -4.474585814165377e-07 -0.08860450250381051 -0.9237000000000001 0.6866739047157423 0.6866715254377244 -4.593485495377192e-07 -0.08860776705296747 -0.9238000000000001 0.6866798413086654 0.6866774709839399 -4.7114502813028203e-07 -0.08861103072338122 -0.9239 0.6866857761288733 0.6866834150015881 -4.828454689270734e-07 -0.08861429351525595 -0.924 0.6866917091778071 0.6866893574900563 -4.944473450951836e-07 -0.08861755542879578 -0.9241 0.6866976404569342 0.6866952984487058 -5.059481516800357e-07 -0.08862081646420478 -0.9242 0.6867035699677484 0.6867012378768718 -5.17345406257641e-07 -0.0886240766216872 -0.9243000000000001 0.6867094977117685 0.6867071757738636 -5.286366493856276e-07 -0.08862733590144696 -0.9244000000000001 0.6867154236905391 0.6867131121389652 -5.398194451999849e-07 -0.08863059430368818 -0.9245 0.6867213479056293 0.6867190469714356 -5.508913818175198e-07 -0.08863385182861488 -0.9246 0.6867272703586337 0.6867249802705082 -5.618500719950514e-07 -0.08863710847643103 -0.9247000000000001 0.6867331910511709 0.6867309120353917 -5.726931535665614e-07 -0.08864036424734051 -0.9248000000000001 0.6867391099848844 0.6867368422652708 -5.834182899844276e-07 -0.08864361914154732 -0.9249 0.6867450271614415 0.6867427709593057 -5.940231708745358e-07 -0.08864687315925536 -0.925 0.6867509425825332 0.6867486981166324 -6.045055122999576e-07 -0.08865012630066846 -0.9251 0.686756856249874 0.6867546237363638 -6.148630576907621e-07 -0.08865337856599043 -0.9252 0.6867627681652018 0.6867605478175893 -6.250935779134048e-07 -0.08865662995542518 -0.9253000000000001 0.6867686783302771 0.6867664703593748 -6.351948718535949e-07 -0.08865988046917643 -0.9254000000000001 0.6867745867468831 0.6867723913607635 -6.451647670546734e-07 -0.08866313010744786 -0.9255 0.6867804934168257 0.686778310820777 -6.550011199951689e-07 -0.08866637887044326 -0.9256 0.6867863983419323 0.6867842287384134 -6.647018167549312e-07 -0.08866962675836633 -0.9257000000000001 0.6867923015240525 0.6867901451126501 -6.742647732510543e-07 -0.08867287377142075 -0.9258000000000001 0.6867982029650568 0.6867960599424422 -6.836879357374759e-07 -0.08867611990981011 -0.9259000000000001 0.6868041026668369 0.6868019732267242 -6.929692814433563e-07 -0.08867936517373803 -0.926 0.6868100006313054 0.686807884964409 -7.02106818725734e-07 -0.08868260956340808 -0.9261 0.686815896860395 0.6868137951543896 -7.110985876940257e-07 -0.08868585307902382 -0.9262 0.686821791356059 0.6868197037955384 -7.199426605292158e-07 -0.0886890957207888 -0.9263000000000001 0.6868276841202698 0.6868256108867078 -7.286371419695792e-07 -0.08869233748890644 -0.9264000000000001 0.6868335751550201 0.6868315164267309 -7.37180169671503e-07 -0.08869557838358025 -0.9265 0.6868394644623201 0.6868374204144218 -7.455699145980654e-07 -0.08869881840501362 -0.9266 0.6868453520441999 0.6868433228485753 -7.538045814631245e-07 -0.08870205755340999 -0.9267000000000001 0.6868512379027081 0.6868492237279682 -7.618824091337739e-07 -0.08870529582897274 -0.9268000000000001 0.6868571220399102 0.6868551230513587 -7.698016708940214e-07 -0.08870853323190517 -0.9269000000000001 0.6868630044578905 0.6868610208174872 -7.775606749166331e-07 -0.08871176976241064 -0.927 0.6868688851587494 0.6868669170250772 -7.851577645406893e-07 -0.08871500542069238 -0.9271 0.6868747641446052 0.6868728116728349 -7.925913187434297e-07 -0.08871824020695372 -0.9272 0.6868806414175919 0.6868787047594495 -7.99859752459442e-07 -0.08872147412139779 -0.9273 0.6868865169798603 0.6868845962835947 -8.069615167888289e-07 -0.0887247071642279 -0.9274000000000001 0.6868923908335762 0.6868904862439278 -8.138950993857863e-07 -0.08872793933564715 -0.9275 0.6868982629809213 0.6868963746390904 -8.206590250137147e-07 -0.0887311706358587 -0.9276 0.6869041334240921 0.6869022614677095 -8.272518555174635e-07 -0.08873440106506567 -0.9277000000000001 0.6869100021652996 0.6869081467283973 -8.336721903090538e-07 -0.08873763062347113 -0.9278000000000001 0.6869158692067694 0.6869140304197507 -8.399186666452341e-07 -0.08874085931127812 -0.9279000000000001 0.6869217345507403 0.6869199125403541 -8.459899599189136e-07 -0.0887440871286897 -0.928 0.6869275981994647 0.6869257930887775 -8.518847838673294e-07 -0.08874731407590884 -0.9281 0.6869334601552082 0.6869316720635781 -8.57601890974502e-07 -0.08875054015313855 -0.9282 0.6869393204202485 0.6869375494633 -8.631400726516469e-07 -0.0887537653605817 -0.9283 0.6869451789968759 0.6869434252864752 -8.684981595424857e-07 -0.08875698969844123 -0.9284000000000001 0.6869510358873923 0.686949299531624 -8.736750217175349e-07 -0.08876021316692002 -0.9285 0.6869568910941107 0.6869551721972549 -8.786695688683954e-07 -0.08876343576622092 -0.9286 0.6869627446193556 0.6869610432818651 -8.834807507102083e-07 -0.08876665749654675 -0.9287000000000001 0.6869685964654613 0.6869669127839422 -8.8810755713431e-07 -0.08876987835810025 -0.9288000000000001 0.6869744466347727 0.686972780701962 -8.925490182914997e-07 -0.08877309835108425 -0.9289000000000001 0.6869802951296442 0.6869786470343919 -8.968042048279612e-07 -0.08877631747570149 -0.929 0.6869861419524395 0.6869845117796893 -9.00872228357108e-07 -0.08877953573215465 -0.9291 0.6869919871055308 0.6869903749363026 -9.047522412652942e-07 -0.08878275312064639 -0.9292 0.6869978305912987 0.6869962365026714 -9.084434371420258e-07 -0.08878596964137934 -0.9293 0.6870036724121323 0.6870020964772279 -9.119450508215943e-07 -0.08878918529455614 -0.9294000000000001 0.687009512570428 0.687007954858396 -9.152563586189988e-07 -0.08879240008037936 -0.9295 0.6870153510685889 0.687013811644593 -9.183766784409686e-07 -0.08879561399905164 -0.9296 0.687021187909025 0.6870196668342285 -9.213053698969853e-07 -0.08879882705077542 -0.9297000000000001 0.6870270230941524 0.6870255204257067 -9.240418345074497e-07 -0.08880203923575322 -0.9298000000000001 0.6870328566263934 0.6870313724174254 -9.265855158424596e-07 -0.08880525055418755 -0.9299000000000001 0.6870386885081747 0.6870372228077766 -9.289358995079322e-07 -0.08880846100628076 -0.93 0.6870445187419288 0.6870430715951479 -9.310925132982595e-07 -0.08881167059223535 -0.9301 0.6870503473300924 0.6870489187779218 -9.330549274044753e-07 -0.08881487931225364 -0.9302 0.687056174275106 0.6870547643544771 -9.348227543448662e-07 -0.08881808716653804 -0.9303 0.6870619995794137 0.6870606083231883 -9.363956491731384e-07 -0.08882129415529082 -0.9304000000000001 0.687067823245463 0.6870664506824271 -9.377733094367846e-07 -0.0888245002787143 -0.9305 0.6870736452757037 0.6870722914305623 -9.389554753436169e-07 -0.08882770553701075 -0.9306 0.687079465672588 0.6870781305659599 -9.399419296785005e-07 -0.0888309099303824 -0.9307000000000001 0.6870852844385698 0.6870839680869848 -9.407324979976428e-07 -0.08883411345903142 -0.9308000000000001 0.6870911015761045 0.6870898039919996 -9.413270484204261e-07 -0.08883731612316004 -0.9309000000000001 0.6870969170876484 0.687095638279366 -9.417254920179863e-07 -0.08884051792297042 -0.931 0.6871027309756583 0.6871014709474459 -9.419277824801453e-07 -0.08884371885866468 -0.9311 0.6871085432425904 0.6871073019945995 -9.419339163513341e-07 -0.08884691893044483 -0.9312 0.687114353890901 0.6871131314191887 -9.417439328085475e-07 -0.08885011813851296 -0.9313 0.6871201629230457 0.6871189592195758 -9.413579138278783e-07 -0.08885331648307117 -0.9314000000000001 0.6871259703414778 0.6871247853941238 -9.407759841428831e-07 -0.0888565139643214 -0.9315 0.68713177614865 0.6871306099411973 -9.399983110641719e-07 -0.08885971058246554 -0.9316 0.6871375803470119 0.6871364328591639 -9.390251045349185e-07 -0.08886290633770565 -0.9317000000000001 0.6871433829390112 0.687142254146393 -9.37856617269639e-07 -0.08886610123024362 -0.9318000000000001 0.6871491839270916 0.6871480738012572 -9.364931442268354e-07 -0.08886929526028134 -0.9319000000000001 0.6871549833136937 0.6871538918221323 -9.349350229420628e-07 -0.08887248842802062 -0.932 0.6871607811012541 0.6871597082073979 -9.331826333613957e-07 -0.08887568073366331 -0.9321 0.687166577292205 0.6871655229554383 -9.312363975638727e-07 -0.08887887217741121 -0.9322 0.6871723718889735 0.6871713360646421 -9.290967799696626e-07 -0.08888206275946607 -0.9323 0.6871781648939816 0.6871771475334038 -9.267642869098536e-07 -0.08888525248002971 -0.9324000000000001 0.6871839563096456 0.6871829573601225 -9.242394667791087e-07 -0.08888844133930376 -0.9325 0.6871897461383751 0.6871887655432038 -9.215229097303546e-07 -0.08889162933748992 -0.9326 0.6871955343825733 0.6871945720810599 -9.186152476192699e-07 -0.0888948164747898 -0.9327000000000001 0.6872013210446364 0.68720037697211 -9.155171538238749e-07 -0.08889800275140503 -0.9328000000000001 0.6872071061269533 0.6872061802147803 -9.12229343147386e-07 -0.08890118816753723 -0.9329000000000001 0.6872128896319046 0.6872119818075049 -9.087525715545386e-07 -0.08890437272338796 -0.933 0.6872186715618629 0.6872177817487263 -9.050876361021976e-07 -0.08890755641915872 -0.9331 0.6872244519191912 0.6872235800368951 -9.01235374717313e-07 -0.088910739255051 -0.9332 0.6872302307062444 0.6872293766704716 -8.971966660165087e-07 -0.08891392123126625 -0.9333 0.6872360079253673 0.6872351716479256 -8.929724290701602e-07 -0.088917102348006 -0.9334000000000001 0.6872417835788943 0.6872409649677362 -8.885636232081051e-07 -0.08892028260547162 -0.9335 0.6872475576691497 0.6872467566283935 -8.839712478947437e-07 -0.08892346200386447 -0.9336 0.6872533301984469 0.6872525466283979 -8.791963423404603e-07 -0.08892664054338599 -0.9337000000000001 0.6872591011690878 0.6872583349662609 -8.742399854044791e-07 -0.08892981822423741 -0.9338000000000001 0.6872648705833627 0.6872641216405055 -8.691032952895528e-07 -0.08893299504662006 -0.9339000000000001 0.6872706384435496 0.6872699066496673 -8.637874292782843e-07 -0.08893617101073521 -0.934 0.6872764047519146 0.6872756899922938 -8.582935835665939e-07 -0.08893934611678411 -0.9341 0.6872821695107096 0.6872814716669451 -8.526229928751405e-07 -0.0889425203649679 -0.9342 0.6872879327221744 0.6872872516721951 -8.467769302272776e-07 -0.0889456937554878 -0.9343 0.6872936943885344 0.6872930300066307 -8.407567067408861e-07 -0.08894886628854498 -0.9344000000000001 0.687299454512001 0.687298806668853 -8.345636711704074e-07 -0.08895203796434051 -0.9345 0.6873052130947714 0.6873045816574774 -8.281992097125546e-07 -0.08895520878307549 -0.9346 0.6873109701390274 0.6873103549711342 -8.216647457287563e-07 -0.088958378744951 -0.9347000000000001 0.6873167256469358 0.6873161266084686 -8.149617393427011e-07 -0.08896154785016802 -0.9348000000000001 0.6873224796206479 0.6873218965681416 -8.080916871489041e-07 -0.08896471609892763 -0.9349000000000001 0.6873282320622981 0.6873276648488298 -8.010561218796397e-07 -0.0889678834914307 -0.935 0.6873339829740053 0.6873334314492265 -7.93856612127386e-07 -0.08897105002787825 -0.9351 0.6873397323578714 0.6873391963680414 -7.864947618452245e-07 -0.08897421570847115 -0.9352 0.6873454802159809 0.6873449596040009 -7.789722101803065e-07 -0.08897738053341031 -0.9353 0.6873512265504007 0.6873507211558492 -7.712906309464973e-07 -0.08898054450289657 -0.9354000000000001 0.68735697136318 0.6873564810223481 -7.634517323884538e-07 -0.08898370761713074 -0.9355 0.6873627146563499 0.6873622392022775 -7.554572566265128e-07 -0.08898686987631359 -0.9356 0.6873684564319227 0.6873679956944356 -7.473089794762799e-07 -0.08899003128064592 -0.9357000000000001 0.6873741966918917 0.6873737504976398 -7.390087099351517e-07 -0.08899319183032849 -0.9358000000000001 0.6873799354382311 0.6873795036107259 -7.30558289779859e-07 -0.08899635152556193 -0.9359000000000001 0.6873856726728952 0.6873852550325499 -7.219595932056455e-07 -0.08899951036654694 -0.936 0.6873914083978188 0.6873910047619871 -7.132145264515666e-07 -0.08900266835348418 -0.9361 0.6873971426149159 0.6873967527979331 -7.043250271621115e-07 -0.08900582548657421 -0.9362 0.6874028753260802 0.6874024991393044 -6.95293064290059e-07 -0.0890089817660177 -0.9363 0.6874086065331844 0.6874082437850376 -6.861206372915651e-07 -0.08901213719201516 -0.9364000000000001 0.6874143362380799 0.6874139867340909 -6.768097761261638e-07 -0.08901529176476713 -0.9365 0.6874200644425963 0.6874197279854433 -6.673625403547101e-07 -0.08901844548447406 -0.9366 0.687425791148542 0.6874254675380961 -6.57781018986725e-07 -0.08902159835133644 -0.9367000000000001 0.6874315163577025 0.6874312053910725 -6.480673298836503e-07 -0.08902475036555475 -0.9368000000000001 0.6874372400718411 0.687436941543418 -6.382236193563928e-07 -0.08902790152732933 -0.9369000000000001 0.6874429622926987 0.6874426759942003 -6.282520616379683e-07 -0.08903105183686062 -0.937 0.6874486830219928 0.6874484087425106 -6.181548585504348e-07 -0.08903420129434891 -0.9371 0.6874544022614171 0.6874541397874625 -6.079342387138587e-07 -0.08903734989999448 -0.9372 0.6874601200126427 0.6874598691281943 -5.97592457435292e-07 -0.08904049765399774 -0.9373 0.6874658362773161 0.6874655967638671 -5.871317958761058e-07 -0.08904364455655887 -0.9374000000000001 0.6874715510570595 0.687471322693666 -5.765545608021894e-07 -0.08904679060787808 -0.9375 0.6874772643534715 0.6874770469168006 -5.658630838761836e-07 -0.08904993580815562 -0.9376 0.6874829761681251 0.6874827694325052 -5.550597212966579e-07 -0.08905308015759164 -0.9377000000000001 0.6874886865025693 0.6874884902400384 -5.441468532291216e-07 -0.0890562236563863 -0.9378000000000001 0.6874943953583272 0.6874942093386842 -5.331268832786673e-07 -0.08905936630473965 -0.9379000000000001 0.6875001027368968 0.6874999267277513 -5.220022379209821e-07 -0.08906250810285181 -0.938 0.6875058086397503 0.6875056424065746 -5.10775366002747e-07 -0.0890656490509228 -0.9381 0.6875115130683341 0.6875113563745141 -4.994487382212198e-07 -0.08906878914915267 -0.9382 0.6875172160240688 0.6875170686309564 -4.880248465968795e-07 -0.08907192839774138 -0.9383 0.687522917508348 0.6875227791753138 -4.7650620378647535e-07 -0.0890750667968889 -0.9384000000000001 0.6875286175225399 0.6875284880070249 -4.648953427777158e-07 -0.08907820434679523 -0.9385 0.6875343160679847 0.6875341951255549 -4.5319481618150137e-07 -0.08908134104766013 -0.9386 0.6875400131459963 0.687539900530396 -4.4140719555885166e-07 -0.08908447689968357 -0.9387000000000001 0.6875457087578618 0.6875456042210675 -4.2953507108783873e-07 -0.08908761190306536 -0.9388000000000001 0.6875514029048402 0.6875513061971151 -4.1758105087663644e-07 -0.08909074605800532 -0.9389000000000001 0.6875570955881636 0.6875570064581127 -4.0554776036677564e-07 -0.08909387936470323 -0.939 0.6875627868090366 0.6875627050036612 -3.934378418127271e-07 -0.08909701182335886 -0.9391 0.6875684765686351 0.6875684018333894 -3.8125395373372895e-07 -0.08910014343417189 -0.9392 0.687574164868108 0.6875740969469538 -3.689987701713249e-07 -0.08910327419734207 -0.9393 0.6875798517085752 0.6875797903440389 -3.5667498030772515e-07 -0.089106404113069 -0.9394000000000001 0.6875855370911288 0.6875854820243577 -3.4428528777191714e-07 -0.08910953318155233 -0.9395 0.687591221016832 0.687591171987651 -3.3183240997353147e-07 -0.08911266140299165 -0.9396 0.6875969034867201 0.6875968602336882 -3.1931907770038626e-07 -0.08911578877758657 -0.9397000000000001 0.6876025845017992 0.6876025467622675 -3.067480343413309e-07 -0.0891189153055366 -0.9398000000000001 0.6876082640630465 0.6876082315732155 -2.9412203534501247e-07 -0.08912204098704124 -0.9399000000000001 0.6876139421714103 0.6876139146663878 -2.8144384767170294e-07 -0.08912516582230001 -0.94 0.6876196188278101 0.6876195960416691 -2.687162491028794e-07 -0.08912828981151234 -0.9401 0.6876252940331355 0.6876252756989727 -2.5594202769652075e-07 -0.08913141295487766 -0.9402 0.6876309677882477 0.6876309536382412 -2.431239811348518e-07 -0.08913453525259535 -0.9403 0.6876366400939777 0.6876366298594467 -2.3026491612065936e-07 -0.08913765670486479 -0.9404000000000001 0.6876423109511277 0.6876423043625903 -2.1736764778401696e-07 -0.08914077731188529 -0.9405 0.6876479803604698 0.6876479771477031 -2.0443499906125373e-07 -0.0891438970738562 -0.9406 0.6876536483227467 0.6876536482148446 -1.914698000253512e-07 -0.08914701599097674 -0.9407000000000001 0.6876593148386712 0.6876593175641048 -1.7847488734124006e-07 -0.08915013406344618 -0.9408000000000001 0.6876649799089267 0.687664985195603 -1.654531036170137e-07 -0.08915325129146373 -0.9409000000000001 0.6876706435341662 0.6876706511094883 -1.524072967672846e-07 -0.08915636767522855 -0.941 0.6876763057150134 0.6876763153059391 -1.3934031939388802e-07 -0.08915948321493979 -0.9411 0.6876819664520617 0.6876819777851642 -1.2625502818913725e-07 -0.08916259791079659 -0.9412 0.6876876257458748 0.6876876385474016 -1.1315428328877164e-07 -0.08916571176299806 -0.9413 0.6876932835969862 0.6876932975929195 -1.0004094764398674e-07 -0.08916882477174325 -0.9414000000000001 0.6876989400058996 0.6876989549220162 -8.691788640474013e-08 -0.08917193693723119 -0.9415 0.6877045949730884 0.6877046105350192 -7.378796628917939e-08 -0.08917504825966088 -0.9416 0.687710248498996 0.6877102644322862 -6.065405496261111e-08 -0.0891781587392313 -0.9417000000000001 0.6877159005840359 0.6877159166142048 -4.7519020405844756e-08 -0.08918126837614135 -0.9418000000000001 0.6877215512285917 0.6877215670811927 -3.438573029399894e-08 -0.08918437717059002 -0.9419000000000001 0.6877272004330166 0.6877272158336971 -2.12570513684774e-08 -0.08918748512277613 -0.942 0.6877328481976339 0.6877328628721955 -8.135848808890622e-09 -0.08919059223289855 -0.9421 0.6877384945227372 0.6877385081971947 4.975014391769839e-09 -0.08919369850115612 -0.9422 0.6877441394085896 0.6877441518092318 1.807267805114393e-08 -0.08919680392774759 -0.9423 0.6877497828554245 0.6877497937088732 3.1154285415335714e-08 -0.08919990851287174 -0.9424000000000001 0.6877554248634458 0.6877554338967157 4.42169837983758e-08 -0.08920301225672739 -0.9425 0.6877610654328267 0.6877610723733851 5.7257925187639835e-08 -0.0892061151595131 -0.9426 0.6877667045637115 0.6877667091395374 7.027426686921634e-08 -0.08920921722142763 -0.9427000000000001 0.6877723422562143 0.6877723441958576 8.326317205327449e-08 -0.08921231844266958 -0.9428000000000001 0.6877779785104197 0.6877779775430608 9.62218104916257e-08 -0.0892154188234376 -0.9429000000000001 0.6877836133263826 0.687783609181891 1.0914735908834627e-07 -0.08921851836393029 -0.943 0.6877892467041284 0.687789239113122 1.2203700252427785e-07 -0.08922161706434616 -0.9431 0.6877948786436532 0.6877948673375562 1.3488793387111953e-07 -0.0892247149248837 -0.9432 0.6878005091449237 0.6878004938560263 1.4769735517602967e-07 -0.08922781194574148 -0.9433 0.6878061382078768 0.6878061186693927 1.6046247810000414e-07 -0.08923090812711787 -0.9434000000000001 0.6878117658324218 0.6878117417785458 1.7318052453196842e-07 -0.0892340034692114 -0.9435 0.6878173920184374 0.6878173631844045 1.8584872718205303e-07 -0.08923709797222042 -0.9436 0.6878230167657743 0.6878229828879163 1.9846433015058285e-07 -0.08924019163634332 -0.9437000000000001 0.6878286400742541 0.6878286008900576 2.110245895733942e-07 -0.08924328446177843 -0.9438000000000001 0.68783426194367 0.6878342171918329 2.2352677422204925e-07 -0.08924637644872405 -0.9439000000000001 0.6878398823737863 0.6878398317942753 2.359681660485391e-07 -0.08924946759737845 -0.944 0.6878455013643395 0.6878454446984461 2.483460608548871e-07 -0.08925255790793994 -0.9441 0.6878511189150374 0.6878510559054346 2.606577687719325e-07 -0.0892556473806067 -0.9442 0.6878567350255601 0.687856665416358 2.729006149879143e-07 -0.08925873601557693 -0.9443 0.6878623496955596 0.687862273232361 2.8507194017174387e-07 -0.08926182381304879 -0.9444000000000001 0.6878679629246601 0.6878678793546165 2.97169101180772e-07 -0.08926491077322041 -0.9445 0.6878735747124585 0.687873483784324 3.0918947154651155e-07 -0.08926799689628986 -0.9446 0.6878791850585244 0.6878790865227106 3.2113044211301567e-07 -0.08927108218245527 -0.9447000000000001 0.6878847939624 0.6878846875710303 3.3298942155035594e-07 -0.08927416663191459 -0.9448000000000001 0.6878904014236007 0.687890286930564 3.4476383695830615e-07 -0.08927725024486592 -0.9449000000000001 0.6878960074416148 0.6878958846026193 3.5645113437288156e-07 -0.08928033302150722 -0.945 0.6879016120159045 0.6879014805885304 3.680487794463505e-07 -0.0892834149620364 -0.9451 0.6879072151459049 0.687907074889657 3.7955425779417906e-07 -0.0892864960666514 -0.9452 0.6879128168310258 0.6879126675073859 3.9096507570279826e-07 -0.08928957633555014 -0.9453 0.6879184170706505 0.6879182584431286 4.022787606430822e-07 -0.08929265576893047 -0.9454000000000001 0.6879240158641368 0.6879238476983227 4.134928617560707e-07 -0.0892957343669902 -0.9455 0.6879296132108168 0.687929435274431 4.24604950387264e-07 -0.08929881212992712 -0.9456 0.6879352091099976 0.6879350211729415 4.356126207041844e-07 -0.08930188905793898 -0.9457000000000001 0.6879408035609613 0.6879406053953669 4.465134901265877e-07 -0.08930496515122355 -0.9458000000000001 0.6879463965629651 0.6879461879432446 4.57305199860758e-07 -0.08930804040997856 -0.9459000000000001 0.6879519881152414 0.6879517688181362 4.679854153782914e-07 -0.08931111483440161 -0.946 0.6879575782169994 0.6879573480216278 4.785518270544742e-07 -0.08931418842469044 -0.9461 0.6879631668674232 0.6879629255553286 4.890021505360442e-07 -0.08931726118104258 -0.9462 0.6879687540656736 0.6879685014208721 4.993341272269136e-07 -0.08932033310365566 -0.9463 0.6879743398108883 0.6879740756199144 5.09545524912669e-07 -0.08932340419272722 -0.9464000000000001 0.6879799241021813 0.6879796481541354 5.196341381075165e-07 -0.08932647444845483 -0.9465 0.6879855069386442 0.6879852190252369 5.295977885400038e-07 -0.08932954387103599 -0.9466 0.6879910883193457 0.6879907882349436 5.394343257636436e-07 -0.0893326124606681 -0.9467000000000001 0.6879966682433323 0.6879963557850022 5.491416274205907e-07 -0.08933568021754866 -0.9468000000000001 0.6880022467096284 0.6880019216771811 5.58717599935532e-07 -0.08933874714187502 -0.9469000000000001 0.6880078237172371 0.6880074859132703 5.681601787099755e-07 -0.08934181323384457 -0.947 0.6880133992651397 0.6880130484950813 5.774673287745058e-07 -0.08934487849365468 -0.9471 0.6880189733522966 0.688018609424446 5.866370451079739e-07 -0.08934794292150261 -0.9472 0.6880245459776474 0.6880241687032175 5.956673530815859e-07 -0.08935100651758571 -0.9473 0.6880301171401115 0.6880297263332685 6.045563090140149e-07 -0.08935406928210118 -0.9474000000000001 0.6880356868385883 0.6880352823164922 6.133020004073231e-07 -0.0893571312152463 -0.9475 0.6880412550719567 0.6880408366548012 6.219025464881955e-07 -0.0893601923172182 -0.9476 0.6880468218390768 0.688046389350127 6.303560985132517e-07 -0.08936325258821405 -0.9477000000000001 0.6880523871387894 0.6880519404044205 6.386608402825233e-07 -0.08936631202843098 -0.9478000000000001 0.688057950969917 0.6880574898196514 6.468149884170105e-07 -0.08936937063806616 -0.9479000000000001 0.6880635133312628 0.688063037597807 6.548167928582815e-07 -0.08937242841731662 -0.948 0.6880690742216129 0.6880685837408931 6.626645371599071e-07 -0.08937548536637938 -0.9481 0.6880746336397352 0.6880741282509322 6.703565388344046e-07 -0.08937854148545149 -0.9482 0.6880801915843802 0.688079671129965 6.778911497834494e-07 -0.08938159677472989 -0.9483 0.6880857480542812 0.6880852123800485 6.852667567003312e-07 -0.08938465123441154 -0.9484000000000001 0.6880913030481561 0.688090752003256 6.924817811948536e-07 -0.08938770486469338 -0.9485 0.688096856564705 0.6880962900016769 6.995346804455904e-07 -0.08939075766577227 -0.9486 0.6881024086026133 0.6881018263774171 7.064239472831524e-07 -0.08939380963784511 -0.9487000000000001 0.6881079591605503 0.6881073611325965 7.131481105926429e-07 -0.0893968607811087 -0.9488000000000001 0.6881135082371707 0.688112894269351 7.19705735591214e-07 -0.08939991109575983 -0.9489000000000001 0.6881190558311137 0.6881184257898305 7.260954243276663e-07 -0.08940296058199526 -0.949 0.6881246019410046 0.6881239556961996 7.323158156546938e-07 -0.08940600924001177 -0.9491 0.6881301465654551 0.6881294839906363 7.383655857978733e-07 -0.08940905707000608 -0.9492 0.6881356897030626 0.6881350106753319 7.442434485360749e-07 -0.08941210407217477 -0.9493 0.6881412313524122 0.6881405357524911 7.499481554790188e-07 -0.08941515024671456 -0.9494000000000001 0.6881467715120753 0.6881460592243307 7.554784962754413e-07 -0.08941819559382204 -0.9495 0.6881523101806117 0.6881515810930803 7.608332990294286e-07 -0.08942124011369376 -0.9496 0.6881578473565692 0.6881571013609808 7.660114302449061e-07 -0.0894242838065264 -0.9497000000000001 0.6881633830384835 0.6881626200302848 7.710117954501383e-07 -0.08942732667251635 -0.9498000000000001 0.6881689172248796 0.6881681371032558 7.758333392532402e-07 -0.08943036871186019 -0.9499000000000001 0.6881744499142715 0.6881736525821676 7.804750454531995e-07 -0.08943340992475433 -0.95 0.6881799811051632 0.6881791664693047 7.849359373868214e-07 -0.08943645031139523 -0.9501000000000001 0.6881855107960486 0.688184678766961 7.892150782062846e-07 -0.0894394898719793 -0.9502 0.688191038985412 0.6881901894774397 7.933115708791405e-07 -0.08944252860670289 -0.9503 0.6881965656717286 0.6881956986030529 7.972245585491367e-07 -0.0894455665157623 -0.9504000000000001 0.6882020908534654 0.6882012061461213 8.009532245500939e-07 -0.08944860359935386 -0.9505 0.6882076145290809 0.6882067121089741 8.044967928083624e-07 -0.08945163985767393 -0.9506 0.6882131366970258 0.6882122164939475 8.078545277317994e-07 -0.08945467529091872 -0.9507000000000001 0.6882186573557432 0.6882177193033847 8.110257346261029e-07 -0.08945770989928441 -0.9508000000000001 0.6882241765036696 0.6882232205396366 8.140097596115448e-07 -0.0894607436829672 -0.9509000000000001 0.6882296941392348 0.6882287202050597 8.16805989928282e-07 -0.08946377664216326 -0.951 0.6882352102608627 0.6882342183020169 8.194138539918683e-07 -0.0894668087770687 -0.9511000000000001 0.6882407248669713 0.6882397148328764 8.218328215459092e-07 -0.08946984008787971 -0.9512 0.6882462379559737 0.6882452098000111 8.240624036204292e-07 -0.08947287057479225 -0.9513 0.6882517495262778 0.6882507032057994 8.261021528926937e-07 -0.08947590023800239 -0.9514000000000001 0.6882572595762875 0.6882561950526231 8.279516635206763e-07 -0.08947892907770616 -0.9515 0.6882627681044025 0.6882616853428681 8.296105714483692e-07 -0.0894819570940995 -0.9516 0.688268275109019 0.6882671740789236 8.310785542531285e-07 -0.08948498428737836 -0.9517 0.6882737805885307 0.6882726612631814 8.323553314509846e-07 -0.08948801065773866 -0.9518000000000001 0.6882792845413281 0.6882781468980365 8.334406643439873e-07 -0.08949103620537631 -0.9519000000000001 0.6882847869658 0.688283630985885 8.343343561451055e-07 -0.08949406093048713 -0.952 0.6882902878603326 0.6882891135291247 8.350362520337384e-07 -0.08949708483326689 -0.9521000000000001 0.688295787223312 0.6882945945301555 8.355462391834712e-07 -0.08950010791391147 -0.9522 0.6883012850531225 0.6883000739913772 8.35864246678808e-07 -0.0895031301726166 -0.9523 0.6883067813481487 0.6883055519151897 8.35990245737217e-07 -0.08950615160957802 -0.9524000000000001 0.6883122761067748 0.688311028303993 8.359242495009633e-07 -0.08950917222499143 -0.9525 0.6883177693273858 0.6883165031601866 8.356663130648645e-07 -0.0895121920190525 -0.9526 0.6883232610083667 0.6883219764861688 8.35216533517924e-07 -0.08951521099195683 -0.9527 0.6883287511481049 0.6883274482843362 8.345750498878202e-07 -0.08951822914390006 -0.9528000000000001 0.6883342397449894 0.6883329185570837 8.337420431409059e-07 -0.08952124647507781 -0.9529000000000001 0.6883397267974112 0.688338387306804 8.327177360434312e-07 -0.08952426298568557 -0.953 0.6883452123037636 0.6883438545358862 8.315023931615428e-07 -0.08952727867591885 -0.9531000000000001 0.6883506962624435 0.6883493202467172 8.30096320819651e-07 -0.08953029354597312 -0.9532 0.6883561786718515 0.68835478444168 8.28499867072674e-07 -0.08953330759604394 -0.9533 0.6883616595303912 0.6883602471231521 8.26713421372971e-07 -0.08953632082632657 -0.9534000000000001 0.6883671388364719 0.6883657082935086 8.247374147923869e-07 -0.08953933323701652 -0.9535 0.6883726165885069 0.6883711679551183 8.225723196475521e-07 -0.08954234482830914 -0.9536 0.6883780927849151 0.6883766261103444 8.202186497496822e-07 -0.08954535560039976 -0.9537 0.688383567424121 0.6883820827615452 8.176769598633449e-07 -0.0895483655534837 -0.9538000000000001 0.6883890405045547 0.6883875379110718 8.149478457897263e-07 -0.08955137468775615 -0.9539000000000001 0.6883945120246542 0.6883929915612694 8.120319442417312e-07 -0.08955438300341248 -0.954 0.6883999819828627 0.6883984437144752 8.089299327329602e-07 -0.08955739050064777 -0.9541000000000001 0.6884054503776323 0.6884038943730195 8.056425292862768e-07 -0.0895603971796573 -0.9542 0.6884109172074223 0.6884093435392242 8.021704923227846e-07 -0.08956340304063615 -0.9543 0.6884163824707 0.6884147912154033 7.985146205508054e-07 -0.08956640808377944 -0.9544000000000001 0.6884218461659419 0.6884202374038615 7.946757527299564e-07 -0.08956941230928227 -0.9545 0.6884273082916335 0.6884256821068943 7.906547674768616e-07 -0.0895724157173397 -0.9546 0.6884327688462692 0.6884311253267881 7.864525830708624e-07 -0.08957541830814685 -0.9547 0.6884382278283543 0.6884365670658186 7.82070157245851e-07 -0.08957842008189856 -0.9548000000000001 0.6884436852364034 0.6884420073262512 7.775084870514926e-07 -0.08958142103878987 -0.9549000000000001 0.6884491410689426 0.6884474461103404 7.727686084646468e-07 -0.08958442117901572 -0.955 0.6884545953245087 0.6884528834203293 7.678515963061017e-07 -0.08958742050277096 -0.9551000000000001 0.6884600480016501 0.6884583192584498 7.627585638658729e-07 -0.08959041901025049 -0.9552 0.6884654990989276 0.6884637536269214 7.574906628060596e-07 -0.08959341670164918 -0.9553 0.6884709486149135 0.6884691865279507 7.520490827583881e-07 -0.08959641357716183 -0.9554000000000001 0.6884763965481938 0.688474617963732 7.464350512964568e-07 -0.0895994096369832 -0.9555 0.6884818428973668 0.6884800479364459 7.406498332140909e-07 -0.08960240488130805 -0.9556 0.6884872876610448 0.6884854764482597 7.346947306641205e-07 -0.08960539931033111 -0.9557 0.6884927308378537 0.6884909035013265 7.285710827004133e-07 -0.08960839292424704 -0.9558000000000001 0.6884981724264339 0.6884963290977848 7.222802650419524e-07 -0.0896113857232505 -0.9559000000000001 0.6885036124254404 0.6885017532397582 7.158236895732362e-07 -0.08961437770753614 -0.956 0.6885090508335434 0.6885071759293555 7.092028042748888e-07 -0.08961736887729856 -0.9561000000000001 0.6885144876494285 0.6885125971686699 7.024190928073271e-07 -0.08962035923273232 -0.9562 0.6885199228717966 0.688518016959778 6.954740741776932e-07 -0.08962334877403194 -0.9563 0.6885253564993651 0.6885234353047408 6.883693023096438e-07 -0.08962633750139189 -0.9564000000000001 0.6885307885308682 0.6885288522056024 6.811063658351824e-07 -0.08962932541500672 -0.9565 0.6885362189650568 0.68853426766439 6.736868876644486e-07 -0.08963231251507085 -0.9566 0.6885416478006985 0.6885396816831131 6.661125246387734e-07 -0.08963529880177866 -0.9567 0.6885470750365792 0.6885450942637634 6.583849672808784e-07 -0.08963828427532453 -0.9568000000000001 0.6885525006715023 0.6885505054083149 6.505059391426204e-07 -0.0896412689359028 -0.9569000000000001 0.68855792470429 0.688555915118723 6.424771966107024e-07 -0.08964425278370784 -0.957 0.6885633471337822 0.6885613233969243 6.34300528629117e-07 -0.08964723581893386 -0.9571000000000001 0.6885687679588387 0.6885667302448364 6.259777559636248e-07 -0.0896502180417752 -0.9572 0.6885741871783382 0.6885721356643576 6.175107311323647e-07 -0.08965319945242607 -0.9573 0.6885796047911787 0.6885775396573659 6.089013378368646e-07 -0.08965618005108067 -0.9574000000000001 0.6885850207962787 0.6885829422257195 6.001514905457084e-07 -0.08965915983793311 -0.9575 0.6885904351925765 0.6885883433712565 5.912631341337127e-07 -0.08966213881317757 -0.9576 0.6885958479790311 0.6885937430957938 5.822382432990603e-07 -0.08966511697700812 -0.9577 0.6886012591546221 0.6885991414011274 5.730788223690109e-07 -0.08966809432961882 -0.9578000000000001 0.6886066687183512 0.688604538289032 5.637869046198896e-07 -0.08967107087120374 -0.9579000000000001 0.6886120766692405 0.6886099337612612 5.543645519162643e-07 -0.08967404660195691 -0.958 0.6886174830063345 0.6886153278195457 5.448138543778791e-07 -0.08967702152207226 -0.9581000000000001 0.6886228877286996 0.6886207204655947 5.351369297551534e-07 -0.08967999563174378 -0.9582 0.6886282908354244 0.6886261117010947 5.253359229434595e-07 -0.0896829689311654 -0.9583 0.6886336923256204 0.6886315015277092 5.154130056639339e-07 -0.08968594142053096 -0.9584000000000001 0.6886390921984218 0.688636889947079 5.053703758112205e-07 -0.08968891310003434 -0.9585 0.688644490452986 0.6886422769608215 4.952102571065264e-07 -0.08969188396986938 -0.9586 0.6886498870884936 0.68864766257053 4.849348985702662e-07 -0.08969485403022981 -0.9587 0.6886552821041496 0.688653046777775 4.745465738975607e-07 -0.08969782328130949 -0.9588000000000001 0.6886606754991822 0.6886584295841016 4.640475812361933e-07 -0.08970079172330203 -0.9589000000000001 0.6886660672728442 0.6886638109910315 4.534402423123085e-07 -0.08970375935640124 -0.959 0.6886714574244128 0.6886691910000615 4.4272690225000133e-07 -0.08970672618080078 -0.9591000000000001 0.6886768459531899 0.6886745696126634 4.3190992884967194e-07 -0.08970969219669422 -0.9592 0.688682232858502 0.6886799468302842 4.209917121647533e-07 -0.08971265740427524 -0.9593 0.6886876181397013 0.6886853226543455 4.099746638772106e-07 -0.08971562180373735 -0.9594000000000001 0.6886930017961648 0.6886906970862431 3.988612169020245e-07 -0.08971858539527415 -0.9595 0.6886983838272956 0.6886960701273479 3.876538247696293e-07 -0.08972154817907918 -0.9596 0.688703764232522 0.6887014417790038 3.763549610638628e-07 -0.08972451015534583 -0.9597 0.688709143011299 0.6887068120425291 3.6496711885297684e-07 -0.08972747132426767 -0.9598000000000001 0.6887145201631073 0.6887121809192156 3.5349281033575375e-07 -0.089730431686038 -0.9599000000000001 0.6887198956874541 0.6887175484103288 3.419345660227169e-07 -0.08973339124085032 -0.96 0.6887252695838729 0.6887229145171074 3.3029493431285806e-07 -0.08973634998889794 -0.9601000000000001 0.6887306418519248 0.6887282792407627 3.1857648096628166e-07 -0.08973930793037421 -0.9602 0.6887360124911968 0.6887336425824797 3.067817884450097e-07 -0.08974226506547239 -0.9603 0.6887413815013038 0.6887390045434154 2.949134554550148e-07 -0.0897452213943858 -0.9604000000000001 0.6887467488818877 0.6887443651246996 2.8297409624539194e-07 -0.08974817691730766 -0.9605 0.6887521146326177 0.6887497243274346 2.709663401226359e-07 -0.08975113163443113 -0.9606 0.6887574787531905 0.6887550821526953 2.5889283085389625e-07 -0.08975408554594945 -0.9607 0.6887628412433309 0.6887604386015281 2.4675622606329384e-07 -0.08975703865205571 -0.9608000000000001 0.6887682021027913 0.6887657936749519 2.345591966906868e-07 -0.08975999095294307 -0.9609000000000001 0.6887735613313521 0.6887711473739571 2.223044263602314e-07 -0.08976294244880455 -0.961 0.6887789189288218 0.6887764996995058 2.0999461077669812e-07 -0.08976589313983327 -0.9611000000000001 0.6887842748950377 0.6887818506525321 1.9763245721893252e-07 -0.0897688430262222 -0.9612 0.6887896292298645 0.688787200233941 1.8522068386331303e-07 -0.0897717921081644 -0.9613 0.688794981933196 0.6887925484446096 1.7276201919394496e-07 -0.08977474038585274 -0.9614000000000001 0.6888003330049545 0.6887978952853857 1.6025920144407957e-07 -0.08977768785948022 -0.9615 0.6888056824450908 0.6888032407570881 1.4771497796814415e-07 -0.08978063452923968 -0.9616 0.6888110302535848 0.6888085848605076 1.3513210462071101e-07 -0.08978358039532407 -0.9617 0.6888163764304449 0.6888139275964048 1.2251334521873325e-07 -0.08978652545792612 -0.9618000000000001 0.6888217209757086 0.6888192689655122 1.0986147083377751e-07 -0.0897894697172387 -0.9619000000000001 0.6888270638894423 0.6888246089685326 9.717925928548476e-08 -0.08979241317345454 -0.962 0.6888324051717412 0.68882994760614 8.446949444074203e-08 -0.08979535582676645 -0.9621000000000001 0.6888377448227301 0.6888352848789787 7.173496567591808e-08 -0.08979829767736702 -0.9622 0.6888430828425627 0.6888406207876643 5.897846722460742e-08 -0.08980123872544907 -0.9623 0.6888484192314219 0.6888459553327821 4.620279758088541e-08 -0.08980417897120514 -0.9624000000000001 0.6888537539895202 0.688851288514889 3.3410758876542546e-08 -0.08980711841482791 -0.9625 0.6888590871170988 0.6888566203345116 2.0605156263522884e-08 -0.08981005705650992 -0.9626 0.6888644186144285 0.6888619507921474 7.788797317179186e-09 -0.08981299489644376 -0.9627 0.6888697484818096 0.6888672798882649 -5.035508599503247e-09 -0.08981593193482197 -0.9628000000000001 0.6888750767195716 0.6888726076233024 -1.786495093872298e-08 -0.08981886817183701 -0.9629000000000001 0.6888804033280731 0.688877933997669 -3.069671859106185e-08 -0.08982180360768138 -0.963 0.6888857283077023 0.6888832590117439 -4.352800049654132e-08 -0.08982473824254744 -0.9631000000000001 0.6888910516588765 0.6888885826658773 -5.635598626793029e-08 -0.08982767207662758 -0.9632000000000001 0.688896373382043 0.68889390496039 -6.917786679692256e-08 -0.08983060511011429 -0.9633 0.6889016934776775 0.6888992258955731 -8.199083487581832e-08 -0.08983353734319978 -0.9634000000000001 0.6889070119462853 0.6889045454716883 -9.479208581183313e-08 -0.08983646877607644 -0.9635 0.6889123287884016 0.6889098636889677 -1.0757881803089009e-07 -0.08983939940893652 -0.9636 0.6889176440045898 0.6889151805476141 -1.2034823371025183e-07 -0.08984232924197222 -0.9637 0.6889229575954431 0.6889204960478011 -1.3309753937526536e-07 -0.08984525827537582 -0.9638000000000001 0.6889282695615837 0.6889258101896734 -1.4582394651171948e-07 -0.08984818650933947 -0.9639000000000001 0.6889335799036627 0.6889311229733457 -1.585246721929473e-07 -0.08985111394405533 -0.964 0.6889388886223602 0.6889364343989042 -1.7119693966269334e-07 -0.08985404057971555 -0.9641000000000001 0.6889441957183854 0.6889417444664054 -1.8383797896134868e-07 -0.08985696641651211 -0.9642000000000001 0.6889495011924762 0.6889470531758776 -1.96445027515757e-07 -0.08985989145463717 -0.9643 0.6889548050453995 0.6889523605273196 -2.090153307619802e-07 -0.08986281569428273 -0.9644000000000001 0.6889601072779505 0.6889576665207013 -2.2154614273683926e-07 -0.08986573913564078 -0.9645 0.6889654078909533 0.6889629711559644 -2.340347266850673e-07 -0.08986866177890329 -0.9646 0.6889707068852602 0.6889682744330216 -2.4647835563870735e-07 -0.08987158362426217 -0.9647 0.6889760042617521 0.688973576351757 -2.588743130277349e-07 -0.08987450467190938 -0.9648000000000001 0.6889813000213381 0.6889788769120265 -2.7121989328374174e-07 -0.08987742492203675 -0.9649000000000001 0.6889865941649553 0.6889841761136575 -2.8351240241586417e-07 -0.08988034437483611 -0.965 0.688991886693569 0.6889894739564497 -2.9574915859365003e-07 -0.08988326303049925 -0.9651000000000001 0.6889971776081723 0.6889947704401742 -3.0792749275421194e-07 -0.08988618088921801 -0.9652000000000001 0.6890024669097856 0.6890000655645746 -3.200447491399916e-07 -0.08988909795118409 -0.9653 0.6890077545994578 0.6890053593293666 -3.320982859544852e-07 -0.08989201421658921 -0.9654 0.6890130406782646 0.689010651734238 -3.440854758757217e-07 -0.08989492968562508 -0.9655 0.689018325147309 0.6890159427788501 -3.560037066460686e-07 -0.08989784435848336 -0.9656 0.6890236080077212 0.689021232462836 -3.6785038162734374e-07 -0.08990075823535561 -0.9657 0.6890288892606584 0.689026520785802 -3.7962292041143764e-07 -0.08990367131643345 -0.9658000000000001 0.6890341689073047 0.6890318077473273 -3.913187593476697e-07 -0.08990658360190845 -0.9659000000000001 0.6890394469488703 0.689037093346965 -4.0293535207708286e-07 -0.08990949509197212 -0.966 0.6890447233865924 0.6890423775842409 -4.144701701500053e-07 -0.08991240578681599 -0.9661000000000001 0.6890499982217342 0.6890476604586546 -4.2592070356034517e-07 -0.08991531568663151 -0.9662000000000001 0.6890552714555844 0.6890529419696799 -4.372844612590687e-07 -0.08991822479161007 -0.9663 0.6890605430894585 0.6890582221167644 -4.4855897168155634e-07 -0.08992113310194316 -0.9664 0.689065813124697 0.6890635008993296 -4.597417833859807e-07 -0.08992404061782205 -0.9665 0.6890710815626655 0.689068778316772 -4.7083046546964047e-07 -0.08992694733943817 -0.9666 0.6890763484047555 0.6890740543684625 -4.81822608172644e-07 -0.08992985326698275 -0.9667 0.689081613652383 0.689079329053747 -4.927158233705708e-07 -0.08993275840064713 -0.9668000000000001 0.6890868773069887 0.6890846023719466 -5.035077451087666e-07 -0.08993566274062254 -0.9669000000000001 0.6890921393700378 0.6890898743223579 -5.141960301088822e-07 -0.08993856628710024 -0.967 0.6890973998430197 0.6890951449042522 -5.247783582823518e-07 -0.08994146904027128 -0.9671000000000001 0.689102658727448 0.6891004141168777 -5.352524332230546e-07 -0.08994437100032697 -0.9672000000000001 0.68910791602486 0.6891056819594588 -5.456159827277318e-07 -0.08994727216745838 -0.9673 0.689113171736816 0.6891109484311951 -5.558667592470146e-07 -0.08995017254185653 -0.9674 0.6891184258648999 0.689116213531264 -5.660025404197189e-07 -0.0899530721237125 -0.9675 0.6891236784107188 0.6891214772588192 -5.760211296002016e-07 -0.08995597091321733 -0.9676 0.689128929375902 0.6891267396129921 -5.859203561914272e-07 -0.0899588689105621 -0.9677 0.6891341787621013 0.6891320005928909 -5.956980762139574e-07 -0.08996176611593767 -0.9678000000000001 0.6891394265709906 0.689137260197602 -6.053521727361622e-07 -0.08996466252953504 -0.9679000000000001 0.689144672804266 0.6891425184261899 -6.148805564709647e-07 -0.08996755815154511 -0.968 0.689149917463644 0.6891477752776967 -6.242811660117642e-07 -0.08997045298215867 -0.9681000000000001 0.6891551605508641 0.6891530307511441 -6.335519683459134e-07 -0.08997334702156667 -0.9682000000000001 0.6891604020676854 0.689158284845532 -6.426909594098307e-07 -0.08997624026995987 -0.9683 0.6891656420158878 0.6891635375598398 -6.516961643943109e-07 -0.08997913272752903 -0.9684 0.6891708803972714 0.6891687888930264 -6.605656382718816e-07 -0.08998202439446486 -0.9685 0.6891761172136572 0.6891740388440305 -6.692974660466033e-07 -0.08998491527095814 -0.9686 0.6891813524668846 0.6891792874117713 -6.778897634618364e-07 -0.08998780535719954 -0.9687 0.6891865861588136 0.6891845345951482 -6.863406770696301e-07 -0.08999069465337976 -0.9688000000000001 0.6891918182913221 0.6891897803930411 -6.946483848552232e-07 -0.08999358315968929 -0.9689000000000001 0.6891970488663077 0.6891950248043118 -7.028110966394996e-07 -0.0899964708763189 -0.969 0.6892022778856854 0.6892002678278031 -7.10827054245522e-07 -0.08999935780345901 -0.9691000000000001 0.6892075053513889 0.6892055094623397 -7.186945321507876e-07 -0.09000224394130021 -0.9692000000000001 0.6892127312653691 0.6892107497067286 -7.264118377925399e-07 -0.09000512929003296 -0.9693 0.6892179556295945 0.6892159885597589 -7.339773116787907e-07 -0.09000801384984772 -0.9694 0.6892231784460507 0.6892212260202033 -7.413893280266981e-07 -0.09001089762093496 -0.9695 0.6892283997167399 0.6892264620868171 -7.486462951233896e-07 -0.09001378060348508 -0.9696 0.6892336194436798 0.6892316967583397 -7.557466555202508e-07 -0.09001666279768844 -0.9697 0.6892388376289048 0.6892369300334938 -7.626888863937475e-07 -0.09001954420373535 -0.9698000000000001 0.6892440542744649 0.6892421619109874 -7.694714999062491e-07 -0.09002242482181617 -0.9699000000000001 0.6892492693824245 0.689247392389512 -7.760930435529723e-07 -0.09002530465212114 -0.97 0.6892544829548635 0.689252621467745 -7.825521004117819e-07 -0.0900281836948405 -0.9701000000000001 0.6892596949938756 0.6892578491443491 -7.888472895317689e-07 -0.09003106195016447 -0.9702000000000001 0.6892649055015689 0.6892630754179725 -7.949772661275389e-07 -0.0900339394182832 -0.9703 0.6892701144800656 0.6892683002872502 -8.009407218984022e-07 -0.09003681609938692 -0.9704 0.6892753219315004 0.6892735237508032 -8.067363854308285e-07 -0.09003969199366575 -0.9705 0.6892805278580213 0.6892787458072396 -8.123630222400813e-07 -0.09004256710130976 -0.9706 0.6892857322617882 0.689283966455155 -8.17819435242062e-07 -0.09004544142250893 -0.9707 0.6892909351449739 0.6892891856931327 -8.231044648782104e-07 -0.09004831495745337 -0.9708000000000001 0.6892961365097623 0.6892944035197442 -8.282169894346936e-07 -0.09005118770633305 -0.9709000000000001 0.6893013363583488 0.6892996199335494 -8.331559252505727e-07 -0.09005405966933792 -0.971 0.6893065346929398 0.6893048349330972 -8.379202270092367e-07 -0.09005693084665795 -0.9711000000000001 0.689311731515752 0.6893100485169259 -8.425088878494247e-07 -0.09005980123848295 -0.9712000000000001 0.689316926829012 0.6893152606835639 -8.469209396427813e-07 -0.09006267084500286 -0.9713 0.6893221206349569 0.689320471431529 -8.51155453188146e-07 -0.09006553966640754 -0.9714 0.6893273129358323 0.6893256807593302 -8.552115384613534e-07 -0.09006840770288677 -0.9715 0.6893325037338925 0.6893308886654671 -8.590883446707442e-07 -0.09007127495463024 -0.9716 0.6893376930314008 0.6893360951484313 -8.627850606179877e-07 -0.09007414142182779 -0.9717 0.6893428808306287 0.6893413002067055 -8.66300914670326e-07 -0.09007700710466911 -0.9718000000000001 0.6893480671338544 0.6893465038387651 -8.696351751075193e-07 -0.0900798720033439 -0.9719000000000001 0.6893532519433645 0.689351706043078 -8.727871502051121e-07 -0.09008273611804181 -0.972 0.6893584352614511 0.6893569068181051 -8.757561882760667e-07 -0.09008559944895245 -0.9721000000000001 0.6893636170904134 0.6893621061623009 -8.785416779205635e-07 -0.09008846199626531 -0.9722000000000001 0.6893687974325565 0.6893673040741137 -8.811430481786564e-07 -0.09009132376017008 -0.9723 0.6893739762901909 0.6893725005519864 -8.835597685719065e-07 -0.09009418474085623 -0.9724 0.6893791536656322 0.6893776955943566 -8.857913492144043e-07 -0.09009704493851325 -0.9725 0.6893843295612005 0.6893828891996565 -8.878373409237916e-07 -0.09009990435333058 -0.9726 0.6893895039792202 0.6893880813663151 -8.896973354155513e-07 -0.09010276298549771 -0.9727 0.6893946769220196 0.6893932720927562 -8.913709651364732e-07 -0.09010562083520397 -0.9728000000000001 0.6893998483919304 0.6893984613774009 -8.928579036671103e-07 -0.09010847790263878 -0.9729000000000001 0.6894050183912869 0.6894036492186668 -8.941578655274895e-07 -0.09011133418799144 -0.973 0.6894101869224262 0.689408835614969 -8.95270606246501e-07 -0.0901141896914512 -0.9731000000000001 0.6894153539876877 0.6894140205647206 -8.9619592259782e-07 -0.09011704441320745 -0.9732000000000001 0.6894205195894118 0.6894192040663323 -8.969336524333738e-07 -0.0901198983534493 -0.9733 0.6894256837299407 0.6894243861182143 -8.974836748498749e-07 -0.09012275151236612 -0.9734 0.6894308464116171 0.6894295667187751 -8.978459100777991e-07 -0.09012560389014697 -0.9735 0.689436007636784 0.6894347458664227 -8.980203197034298e-07 -0.09012845548698098 -0.9736 0.6894411674077844 0.6894399235595654 -8.980069064190577e-07 -0.09013130630305731 -0.9737 0.689446325726961 0.689445099796612 -8.978057141340035e-07 -0.09013415633856503 -0.9738000000000001 0.6894514825966551 0.6894502745759714 -8.97416827946862e-07 -0.0901370055936932 -0.9739000000000001 0.6894566380192075 0.6894554478960547 -8.968403742287689e-07 -0.0901398540686309 -0.974 0.6894617919969561 0.6894606197552738 -8.960765203597232e-07 -0.09014270176356702 -0.9741000000000001 0.689466944532237 0.689465790152043 -8.951254748534865e-07 -0.09014554867869057 -0.9742000000000001 0.6894720956273838 0.6894709590847792 -8.939874872881948e-07 -0.09014839481419046 -0.9743 0.6894772452847266 0.6894761265519018 -8.926628480843135e-07 -0.09015124017025555 -0.9744 0.6894823935065926 0.6894812925518342 -8.911518887544378e-07 -0.09015408474707473 -0.9745 0.6894875402953047 0.6894864570830033 -8.894549815008368e-07 -0.09015692854483684 -0.9746 0.6894926856531812 0.6894916201438404 -8.87572539229331e-07 -0.0901597715637307 -0.9747 0.6894978295825358 0.6894967817327808 -8.855050155909261e-07 -0.09016261380394501 -0.9748000000000001 0.6895029720856771 0.6895019418482656 -8.83252904704257e-07 -0.09016545526566855 -0.9749000000000001 0.6895081131649081 0.6895071004887413 -8.808167410584433e-07 -0.09016829594909001 -0.975 0.6895132528225253 0.6895122576526602 -8.781970994575783e-07 -0.0901711358543981 -0.9751000000000001 0.6895183910608189 0.6895174133384807 -8.753945949097064e-07 -0.09017397498178141 -0.9752000000000001 0.6895235278820724 0.6895225675446683 -8.724098823353899e-07 -0.09017681333142857 -0.9753000000000001 0.6895286632885615 0.6895277202696958 -8.692436566509754e-07 -0.09017965090352817 -0.9754 0.6895337972825548 0.689532871512043 -8.658966522967493e-07 -0.09018248769826875 -0.9755 0.689538929866312 0.6895380212701985 -8.623696433063266e-07 -0.09018532371583882 -0.9756 0.6895440610420851 0.6895431695426584 -8.586634430846063e-07 -0.09018815895642686 -0.9757 0.6895491908121163 0.6895483163279286 -8.547789041579712e-07 -0.09019099342022135 -0.9758000000000001 0.6895543191786389 0.6895534616245234 -8.507169181187768e-07 -0.09019382710741068 -0.9759000000000001 0.6895594461438759 0.689558605430967 -8.464784151951399e-07 -0.09019666001818322 -0.976 0.6895645717100407 0.6895637477457943 -8.42064364278694e-07 -0.09019949215272738 -0.9761 0.6895696958793356 0.6895688885675499 -8.374757725498894e-07 -0.09020232351123142 -0.9762000000000001 0.6895748186539521 0.6895740278947894 -8.327136852975814e-07 -0.09020515409388369 -0.9763000000000001 0.6895799400360705 0.6895791657260799 -8.277791856275973e-07 -0.09020798390087248 -0.9764 0.6895850600278591 0.6895843020599998 -8.226733943517139e-07 -0.09021081293238596 -0.9765 0.6895901786314736 0.6895894368951394 -8.173974696407127e-07 -0.09021364118861228 -0.9766 0.6895952958490581 0.6895945702301023 -8.119526067190685e-07 -0.0902164686697397 -0.9767 0.6896004116827427 0.6895997020635041 -8.063400376429053e-07 -0.09021929537595637 -0.9768000000000001 0.6896055261346448 0.689604832393974 -8.005610311612177e-07 -0.09022212130745033 -0.9769000000000001 0.6896106392068675 0.6896099612201543 -7.946168922023933e-07 -0.09022494646440964 -0.977 0.6896157509015007 0.6896150885407019 -7.88508961707679e-07 -0.09022777084702244 -0.9771 0.689620861220619 0.6896202143542877 -7.822386162287254e-07 -0.09023059445547665 -0.9772000000000001 0.6896259701662824 0.689625338659597 -7.758072678026862e-07 -0.09023341728996026 -0.9773000000000001 0.6896310777405357 0.6896304614553305 -7.692163634526183e-07 -0.09023623935066122 -0.9774 0.6896361839454082 0.6896355827402046 -7.624673849099262e-07 -0.09023906063776746 -0.9775 0.6896412887829131 0.689640702512951 -7.555618484617055e-07 -0.09024188115146686 -0.9776 0.6896463922550473 0.6896458207723174 -7.485013042568545e-07 -0.09024470089194724 -0.9777 0.6896514943637915 0.6896509375170689 -7.412873362366845e-07 -0.09024751985939646 -0.9778000000000001 0.6896565951111087 0.6896560527459866 -7.339215617879757e-07 -0.09025033805400232 -0.9779000000000001 0.6896616944989451 0.6896611664578692 -7.264056311878653e-07 -0.09025315547595256 -0.978 0.6896667925292287 0.689666278651533 -7.187412273262916e-07 -0.09025597212543494 -0.9781 0.6896718892038698 0.6896713893258114 -7.109300654978279e-07 -0.09025878800263704 -0.9782000000000001 0.6896769845247603 0.6896764984795571 -7.029738927077922e-07 -0.09026160310774664 -0.9783000000000001 0.6896820784937732 0.6896816061116406 -6.948744875612256e-07 -0.0902644174409513 -0.9784 0.6896871711127628 0.6896867122209518 -6.866336596245137e-07 -0.09026723100243864 -0.9785 0.689692262383564 0.6896918168063995 -6.782532492866089e-07 -0.09027004379239624 -0.9786 0.6896973523079917 0.6896969198669116 -6.69735127120652e-07 -0.09027285581101163 -0.9787 0.6897024408878412 0.6897020214014367 -6.610811935786609e-07 -0.09027566705847231 -0.9788000000000001 0.6897075281248876 0.6897071214089431 -6.522933784780527e-07 -0.09027847753496582 -0.9789000000000001 0.6897126140208847 0.6897122198884192 -6.433736408073543e-07 -0.09028128724067949 -0.979 0.6897176985775662 0.6897173168388747 -6.343239679490464e-07 -0.09028409617580077 -0.9791 0.6897227817966438 0.6897224122593397 -6.251463755546638e-07 -0.09028690434051696 -0.9792000000000001 0.6897278636798088 0.6897275061488666 -6.15842906864783e-07 -0.09028971173501556 -0.9793000000000001 0.6897329442287301 0.6897325985065283 -6.064156323065673e-07 -0.0902925183594838 -0.9794 0.6897380234450545 0.6897376893314204 -5.968666491468211e-07 -0.09029532421410896 -0.9795 0.6897431013304067 0.6897427786226604 -5.871980810062682e-07 -0.09029812929907832 -0.9796 0.6897481778863884 0.6897478663793879 -5.774120772211733e-07 -0.09030093361457907 -0.9797 0.6897532531145791 0.6897529526007657 -5.67510812482519e-07 -0.0903037371607984 -0.9798000000000001 0.6897583270165348 0.6897580372859793 -5.574964863919174e-07 -0.09030653993792344 -0.9799000000000001 0.6897633995937882 0.6897631204342375 -5.473713229620092e-07 -0.09030934194614139 -0.98 0.6897684708478482 0.6897682020447725 -5.37137570019719e-07 -0.0903121431856393 -0.9801 0.6897735407801999 0.6897732821168401 -5.267974988454327e-07 -0.09031494365660415 -0.9802000000000001 0.6897786093923046 0.6897783606497205 -5.163534035831918e-07 -0.0903177433592231 -0.9803000000000001 0.6897836766855991 0.6897834376427177 -5.058076006786427e-07 -0.09032054229368308 -0.9804 0.6897887426614955 0.68978851309516 -4.951624285043366e-07 -0.09032334046017107 -0.9805 0.689793807321381 0.6897935870064009 -4.844202468115566e-07 -0.09032613785887399 -0.9806 0.689798870666618 0.6897986593758182 -4.7358343613357334e-07 -0.09032893448997875 -0.9807 0.6898039326985437 0.689803730202815 -4.6265439732767755e-07 -0.09033173035367222 -0.9808000000000001 0.6898089934184699 0.6898087994868198 -4.5163555097843533e-07 -0.09033452545014124 -0.9809000000000001 0.6898140528276822 0.6898138672272865 -4.4052933696053787e-07 -0.0903373197795726 -0.981 0.6898191109274412 0.6898189334236946 -4.2933821376572867e-07 -0.09034011334215311 -0.9811 0.6898241677189809 0.6898239980755494 -4.1806465810034776e-07 -0.09034290613806945 -0.9812000000000001 0.6898292232035095 0.6898290611823823 -4.0671116418450337e-07 -0.0903456981675084 -0.9813000000000001 0.6898342773822081 0.6898341227437514 -3.9528024337737167e-07 -0.09034848943065663 -0.9814 0.6898393302562321 0.6898391827592407 -3.8377442348330737e-07 -0.09035127992770076 -0.9815 0.6898443818267095 0.6898442412284607 -3.721962482522434e-07 -0.09035406965882738 -0.9816 0.6898494320947421 0.6898492981510487 -3.6054827681070156e-07 -0.09035685862422314 -0.9817 0.6898544810614042 0.6898543535266697 -3.488330830511699e-07 -0.0903596468240746 -0.9818000000000001 0.6898595287277426 0.6898594073550142 -3.3705325516025786e-07 -0.0903624342585682 -0.9819000000000001 0.6898645750947773 0.6898644596358012 -3.2521139495950147e-07 -0.09036522092789048 -0.982 0.6898696201635005 0.6898695103687766 -3.133101173849462e-07 -0.09036800683222787 -0.9821 0.6898746639348772 0.6898745595537137 -3.013520498695854e-07 -0.09037079197176683 -0.9822000000000001 0.6898797064098439 0.6898796071904136 -2.8933983179518785e-07 -0.09037357634669374 -0.9823000000000001 0.68988474758931 0.6898846532787049 -2.772761139094304e-07 -0.09037635995719495 -0.9824 0.6898897874741564 0.6898896978184437 -2.651635577256839e-07 -0.0903791428034568 -0.9825 0.6898948260652368 0.6898947408095146 -2.5300483489851255e-07 -0.09038192488566561 -0.9826 0.6898998633633755 0.68989978225183 -2.408026267101959e-07 -0.09038470620400761 -0.9827 0.6899048993693693 0.6899048221453303 -2.2855962348092285e-07 -0.09038748675866905 -0.9828000000000001 0.6899099340839865 0.6899098604899845 -2.162785238610243e-07 -0.09039026654983616 -0.9829000000000001 0.6899149675079669 0.6899148972857891 -2.039620343799453e-07 -0.09039304557769505 -0.983 0.6899199996420216 0.6899199325327701 -1.9161286877317218e-07 -0.09039582384243189 -0.9831 0.6899250304868336 0.6899249662309808 -1.7923374736120157e-07 -0.0903986013442328 -0.9832000000000001 0.6899300600430567 0.6899299983805036 -1.668273965534095e-07 -0.09040137808328384 -0.9833000000000001 0.6899350883113162 0.6899350289814496 -1.5439654812293702e-07 -0.09040415405977105 -0.9834 0.6899401152922089 0.6899400580339583 -1.4194393868453836e-07 -0.0904069292738805 -0.9835 0.6899451409863026 0.6899450855381974 -1.2947230907875418e-07 -0.09040970372579808 -0.9836 0.6899501653941361 0.6899501114943641 -1.1698440375608465e-07 -0.09041247741570982 -0.9837 0.6899551885162193 0.689955135902684 -1.0448297017157104e-07 -0.0904152503438016 -0.9838000000000001 0.6899602103530335 0.6899601587634111 -9.197075819759176e-08 -0.09041802251025927 -0.9839000000000001 0.6899652309050309 0.6899651800768287 -7.945051950109666e-08 -0.09042079391526875 -0.984 0.6899702501726348 0.6899701998432486 -6.692500695640313e-08 -0.09042356455901585 -0.9841 0.6899752681562392 0.6899752180630112 -5.439697401982829e-08 -0.0904263344416863 -0.9842000000000001 0.6899802848562101 0.6899802347364863 -4.1869174136630397e-08 -0.0904291035634659 -0.9843000000000001 0.6899853002728835 0.6899852498640718 -2.934436013808401e-08 -0.0904318719245404 -0.9844 0.6899903144065671 0.6899902634461949 -1.682528362944788e-08 -0.09043463952509545 -0.9845 0.6899953272575396 0.6899952754833109 -4.31469438736537e-09 -0.09043740636531669 -0.9846 0.6900003388260506 0.6900002859759047 8.184660242084585e-09 -0.09044017244538984 -0.9847 0.6900053491123208 0.690005294924489 2.0670035949348076e-08 -0.09044293776550036 -0.9848000000000001 0.6900103581165427 0.6900103023296065 3.3138692059550556e-08 -0.09044570232583399 -0.9849000000000001 0.6900153658388795 0.6900153081918268 4.558789213834902e-08 -0.09044846612657617 -0.985 0.6900203722794656 0.690020312511749 5.801490459561576e-08 -0.09045122916791241 -0.9851 0.6900253774384071 0.6900253152900007 7.041700328044853e-08 -0.09045399145002818 -0.9852000000000001 0.6900303813157813 0.690030316527238 8.279146807357862e-08 -0.0904567529731089 -0.9853000000000001 0.6900353839116369 0.690035316224145 9.513558549278933e-08 -0.09045951373734001 -0.9854 0.6900403852259944 0.6900403143814344 1.074466492931303e-07 -0.09046227374290688 -0.9855 0.6900453852588457 0.690045310999847 1.1972196103937627e-07 -0.09046503298999481 -0.9856 0.6900503840101548 0.690050306080152 1.319588307235886e-07 -0.09046779147878925 -0.9857 0.6900553814798568 0.6900552996231462 1.4415457734451298e-07 -0.09047054920947535 -0.9858000000000001 0.6900603776678593 0.6900602916296541 1.5630652948350754e-07 -0.09047330618223835 -0.9859000000000001 0.6900653725740418 0.6900652821005293 1.684120258943489e-07 -0.09047606239726355 -0.986 0.6900703661982556 0.6900702710366518 1.8046841611038533e-07 -0.09047881785473609 -0.9861 0.6900753585403245 0.6900752584389296 1.924730609961789e-07 -0.0904815725548411 -0.9862000000000001 0.6900803496000449 0.6900802443082984 2.0442333332343354e-07 -0.09048432649776371 -0.9863000000000001 0.6900853393771855 0.6900852286457211 2.1631661838161786e-07 -0.09048707968368902 -0.9864 0.6900903278714875 0.6900902114521881 2.281503145296071e-07 -0.09048983211280212 -0.9865 0.6900953150826652 0.690095192728716 2.3992183374038634e-07 -0.09049258378528802 -0.9866 0.6901003010104052 0.6901001724763494 2.5162860219779537e-07 -0.09049533470133164 -0.9867 0.6901052856543679 0.690105150696159 2.6326806084470133e-07 -0.09049808486111807 -0.9868000000000001 0.6901102690141867 0.6901101273892422 2.7483766598668247e-07 -0.09050083426483216 -0.9869000000000001 0.6901152510894683 0.6901151025567229 2.863348897708118e-07 -0.09050358291265881 -0.987 0.6901202318797929 0.6901200761997512 2.9775722078934086e-07 -0.09050633080478289 -0.9871 0.6901252113847146 0.6901250483195038 3.091021646486891e-07 -0.09050907794138927 -0.9872000000000001 0.6901301896037617 0.6901300189171824 3.2036724442047193e-07 -0.09051182432266269 -0.9873000000000001 0.6901351665364359 0.6901349879940148 3.3155000130763446e-07 -0.09051456994878793 -0.9874 0.6901401421822142 0.6901399555512548 3.426479950954797e-07 -0.09051731481994979 -0.9875 0.6901451165405477 0.6901449215901809 3.536588047206579e-07 -0.09052005893633296 -0.9876 0.6901500896108614 0.6901498861120969 3.6458002879158347e-07 -0.090522802298122 -0.9877 0.6901550613925567 0.6901548491183316 3.7540928608803537e-07 -0.09052554490550169 -0.9878000000000001 0.6901600318850093 0.6901598106102383 3.8614421608157423e-07 -0.09052828675865661 -0.9879000000000001 0.6901650010875703 0.6901647705891949 3.9678247954616497e-07 -0.09053102785777128 -0.988 0.6901699689995668 0.6901697290566038 4.073217589536937e-07 -0.09053376820303034 -0.9881 0.6901749356203013 0.6901746860138905 4.1775975901520157e-07 -0.0905365077946182 -0.9882000000000001 0.6901799009490526 0.6901796414625055 4.2809420720824054e-07 -0.09053924663271945 -0.9883000000000001 0.6901848649850757 0.6901845954039219 4.383228542279016e-07 -0.0905419847175184 -0.9884000000000001 0.6901898277276024 0.6901895478396364 4.484434744933541e-07 -0.09054472204919957 -0.9885 0.6901947891758411 0.6901944987711689 4.5845386670295696e-07 -0.09054745862794736 -0.9886 0.6901997493289779 0.6901994482000616 4.683518541187537e-07 -0.09055019445394612 -0.9887 0.690204708186175 0.6902043961278795 4.78135285295056e-07 -0.09055292952738009 -0.9888000000000001 0.6902096657465735 0.6902093425562101 4.878020343768164e-07 -0.09055566384843369 -0.9889000000000001 0.6902146220092916 0.690214287486662 4.973500016269838e-07 -0.09055839741729106 -0.989 0.6902195769734261 0.6902192309208666 5.067771138150823e-07 -0.09056113023413652 -0.9891 0.6902245306380517 0.6902241728604757 5.160813247584439e-07 -0.0905638622991542 -0.9892000000000001 0.6902294830022224 0.6902291133071627 5.252606157385431e-07 -0.09056659361252828 -0.9893000000000001 0.6902344340649711 0.690234052262622 5.343129958895743e-07 -0.09056932417444293 -0.9894000000000001 0.69023938382531 0.6902389897285679 5.432365026841746e-07 -0.09057205398508222 -0.9895 0.6902443322822307 0.6902439257067354 5.520292024191464e-07 -0.09057478304463017 -0.9896 0.690249279434705 0.6902488601988794 5.606891903681133e-07 -0.0905775113532709 -0.9897 0.6902542252816851 0.6902537932067742 5.692145916280644e-07 -0.09058023891118837 -0.9898 0.6902591698221032 0.6902587247322134 5.776035610638441e-07 -0.09058296571856654 -0.9899000000000001 0.6902641130548729 0.6902636547770096 5.858542841130632e-07 -0.09058569177558935 -0.99 0.6902690549788886 0.6902685833429941 5.9396497684161e-07 -0.0905884170824407 -0.9901 0.6902739955930266 0.6902735104320168 6.019338865959067e-07 -0.09059114163930454 -0.9902000000000001 0.6902789348961451 0.6902784360459451 6.097592921971984e-07 -0.09059386544636464 -0.9903000000000001 0.6902838728870841 0.6902833601866643 6.174395044550307e-07 -0.09059658850380486 -0.9904000000000001 0.6902888095646662 0.6902882828560768 6.249728664309284e-07 -0.09059931081180893 -0.9905 0.6902937449276971 0.6902932040561023 6.323577537853398e-07 -0.09060203237056062 -0.9906 0.6902986789749656 0.6902981237886769 6.395925752911147e-07 -0.09060475318024364 -0.9907 0.6903036117052439 0.6903030420557532 6.46675772958405e-07 -0.0906074732410417 -0.9908 0.6903085431172885 0.6903079588592995 6.536058224926311e-07 -0.09061019255313843 -0.9909000000000001 0.6903134732098399 0.6903128742012998 6.603812335997938e-07 -0.09061291111671746 -0.991 0.6903184019816233 0.6903177880837528 6.670005503334187e-07 -0.09061562893196232 -0.9911 0.690323329431349 0.6903227005086732 6.734623513998672e-07 -0.09061834599905665 -0.9912000000000001 0.6903282555577124 0.6903276114780892 6.797652503942597e-07 -0.09062106231818395 -0.9913000000000001 0.690333180359395 0.6903325209940432 6.85907896189053e-07 -0.09062377788952766 -0.9914000000000001 0.690338103835064 0.690337429058592 6.918889732115963e-07 -0.09062649271327135 -0.9915 0.6903430259833736 0.6903423356738049 6.977072016661756e-07 -0.09062920678959835 -0.9916 0.6903479468029641 0.6903472408417648 7.033613379087145e-07 -0.09063192011869209 -0.9917 0.6903528662924637 0.690352144564567 7.088501745994291e-07 -0.0906346327007359 -0.9918 0.6903577844504885 0.6903570468443188 7.141725409803845e-07 -0.09063734453591321 -0.9919000000000001 0.6903627012756415 0.6903619476831395 7.193273032363168e-07 -0.09064005562440719 -0.992 0.6903676167665149 0.6903668470831602 7.243133646611666e-07 -0.0906427659664012 -0.9921 0.6903725309216897 0.6903717450465228 7.291296658107349e-07 -0.09064547556207844 -0.9922000000000001 0.690377443739736 0.6903766415753794 7.337751848357499e-07 -0.09064818441162213 -0.9923000000000001 0.690382355219213 0.690381536671893 7.382489377871781e-07 -0.09065089251521541 -0.9924000000000001 0.6903872653586705 0.6903864303382359 7.425499785329581e-07 -0.0906535998730414 -0.9925 0.6903921741566488 0.6903913225765906 7.466773992437226e-07 -0.09065630648528328 -0.9926 0.6903970816116785 0.6903962133891481 7.506303305176987e-07 -0.09065901235212412 -0.9927 0.6904019877222811 0.6904011027781083 7.544079414084637e-07 -0.09066171747374689 -0.9928 0.6904068924869706 0.6904059907456791 7.580094398412784e-07 -0.09066442185033469 -0.9929000000000001 0.6904117959042524 0.6904108772940766 7.614340725298208e-07 -0.09066712548207043 -0.993 0.6904166979726247 0.6904157624255239 7.6468112532313e-07 -0.0906698283691371 -0.9931 0.6904215986905781 0.6904206461422515 7.677499233860186e-07 -0.09067253051171761 -0.9932000000000001 0.6904264980565965 0.6904255284464962 7.70639831032538e-07 -0.09067523190999478 -0.9933000000000001 0.6904313960691579 0.6904304093405015 7.733502522810909e-07 -0.09067793256415158 -0.9934000000000001 0.6904362927267336 0.690435288826516 7.75880630646264e-07 -0.09068063247437069 -0.9935 0.6904411880277905 0.6904401669067941 7.782304494025061e-07 -0.09068333164083506 -0.9936 0.6904460819707892 0.6904450435835952 7.803992316951502e-07 -0.09068603006372732 -0.9937 0.6904509745541865 0.6904499188591828 7.82386540609803e-07 -0.09068872774323024 -0.9938 0.6904558657764341 0.6904547927358249 7.841919791862217e-07 -0.09069142467952648 -0.9939000000000001 0.6904607556359812 0.690459665215793 7.858151906542377e-07 -0.09069412087279877 -0.994 0.6904656441312719 0.6904645363013621 7.872558583643663e-07 -0.09069681632322962 -0.9941 0.6904705312607485 0.6904694059948094 7.885137059404634e-07 -0.09069951103100171 -0.9942000000000001 0.6904754170228506 0.6904742742984155 7.895884972797251e-07 -0.09070220499629758 -0.9943000000000001 0.6904803014160151 0.6904791412144622 7.904800366359543e-07 -0.09070489821929975 -0.9944000000000001 0.6904851844386778 0.6904840067452332 7.911881685224165e-07 -0.09070759070019077 -0.9945 0.6904900660892728 0.6904888708930135 7.91712778058784e-07 -0.09071028243915306 -0.9946 0.6904949463662333 0.6904937336600883 7.920537905548031e-07 -0.09071297343636907 -0.9947 0.6904998252679924 0.6904985950487434 7.922111719127489e-07 -0.09071566369202122 -0.9948 0.6905047027929829 0.6905034550612648 7.921849283082372e-07 -0.09071835320629182 -0.9949000000000001 0.690509578939638 0.6905083136999373 7.919751064955349e-07 -0.09072104197936326 -0.995 0.6905144537063919 0.6905131709670451 7.915817935161273e-07 -0.09072373001141781 -0.9951 0.6905193270916796 0.6905180268648714 7.910051168236176e-07 -0.0907264173026378 -0.9952000000000001 0.6905241990939384 0.6905228813956967 7.902452441171937e-07 -0.09072910385320541 -0.9953000000000001 0.6905290697116073 0.6905277345617999 7.893023834387725e-07 -0.0907317896633029 -0.9954000000000001 0.690533938943128 0.690532586365457 7.881767831313669e-07 -0.09073447473311243 -0.9955 0.6905388067869448 0.690537436808941 7.86868731672552e-07 -0.09073715906281614 -0.9956 0.6905436732415056 0.690542285894521 7.853785575356875e-07 -0.09073984265259612 -0.9957 0.690548538305262 0.6905471336244631 7.837066293286954e-07 -0.09074252550263447 -0.9958 0.6905534019766699 0.690551980001028 7.818533555581375e-07 -0.09074520761311325 -0.9959000000000001 0.6905582642541898 0.6905568250264725 7.798191845598268e-07 -0.09074788898421444 -0.996 0.6905631251362869 0.6905616687030477 7.776046043878049e-07 -0.09075056961612009 -0.9961 0.6905679846214328 0.6905665110329993 7.752101427171976e-07 -0.09075324950901213 -0.9962000000000001 0.6905728427081036 0.6905713520185667 7.726363666776814e-07 -0.09075592866307246 -0.9963000000000001 0.6905776993947825 0.6905761916619831 7.698838828673615e-07 -0.09075860707848295 -0.9964000000000001 0.6905825546799595 0.6905810299654754 7.669533369641934e-07 -0.09076128475542555 -0.9965 0.6905874085621315 0.6905858669312623 7.638454137398609e-07 -0.09076396169408206 -0.9966 0.6905922610398025 0.6905907025615554 7.605608369071204e-07 -0.09076663789463418 -0.9967 0.6905971121114847 0.6905955368585579 7.571003688838784e-07 -0.09076931335726375 -0.9968 0.6906019617756988 0.6906003698244649 7.53464810654414e-07 -0.09077198808215246 -0.9969000000000001 0.6906068100309739 0.6906052014614625 7.496550016167225e-07 -0.09077466206948202 -0.997 0.6906116568758482 0.6906100317717274 7.456718193743495e-07 -0.09077733531943405 -0.9971 0.6906165023088702 0.6906148607574268 7.415161793755676e-07 -0.09078000783219024 -0.9972000000000001 0.6906213463285971 0.6906196884207181 7.371890349827659e-07 -0.0907826796079322 -0.9973000000000001 0.6906261889335974 0.6906245147637475 7.326913770699939e-07 -0.09078535064684146 -0.9974000000000001 0.6906310301224496 0.6906293397886509 7.280242339258169e-07 -0.09078802094909959 -0.9975 0.6906358698937439 0.690634163497553 7.23188670823105e-07 -0.09079069051488807 -0.9976 0.6906407082460817 0.6906389858925667 7.18185789921888e-07 -0.09079335934438841 -0.9977 0.6906455451780757 0.6906438069757928 7.130167299779222e-07 -0.09079602743778198 -0.9978 0.6906503806883519 0.6906486267493195 7.076826661622793e-07 -0.09079869479525021 -0.9979000000000001 0.6906552147755481 0.6906534452152229 7.021848096866457e-07 -0.09080136141697448 -0.998 0.6906600474383155 0.6906582623755654 6.965244075396448e-07 -0.09080402730313615 -0.9981 0.6906648786753184 0.6906630782323961 6.907027422925482e-07 -0.09080669245391651 -0.9982000000000001 0.6906697084852351 0.6906678927877503 6.847211317523305e-07 -0.09080935686949686 -0.9983000000000001 0.690674536866758 0.6906727060436489 6.785809286979916e-07 -0.09081202055005841 -0.9984000000000001 0.6906793638185934 0.6906775180020982 6.722835204087119e-07 -0.09081468349578241 -0.9985 0.6906841893394633 0.6906823286650893 6.658303287193634e-07 -0.09081734570685 -0.9986 0.6906890134281046 0.6906871380345984 6.592228092849872e-07 -0.09082000718344241 -0.9987 0.6906938360832693 0.6906919461125856 6.524624514697708e-07 -0.09082266792574067 -0.9988 0.6906986573037256 0.6906967529009951 6.455507780001035e-07 -0.09082532793392588 -0.9989000000000001 0.6907034770882581 0.6907015584017551 6.384893446037543e-07 -0.09082798720817914 -0.999 0.6907082954356676 0.6907063626167764 6.31279739635171e-07 -0.09083064574868142 -0.9991 0.6907131123447725 0.6907111655479532 6.239235838811918e-07 -0.09083330355561378 -0.9992000000000001 0.6907179278144078 0.6907159671971619 6.164225298255221e-07 -0.09083596062915711 -0.9993000000000001 0.6907227418434259 0.6907207675662617 6.08778261759757e-07 -0.09083861696949234 -0.9994000000000001 0.6907275544306977 0.6907255666570935 6.009924950201029e-07 -0.09084127257680041 -0.9995 0.6907323655751123 0.6907303644714795 5.930669757098217e-07 -0.09084392745126216 -0.9996 0.6907371752755771 0.6907351610112233 5.850034804355531e-07 -0.09084658159305838 -0.9997 0.6907419835310185 0.6907399562781101 5.768038158077138e-07 -0.09084923500236991 -0.9998 0.6907467903403819 0.6907447502739048 5.684698180102865e-07 -0.09085188767937752 -0.9999000000000001 0.6907515957026324 0.6907495430003533 5.600033524122416e-07 -0.09085453962426188 -1.0 0.6907563996167552 0.6907543344591814 5.514063132899816e-07 -0.09085719083720374 -1.0001 0.6907612020817545 0.6907591246520949 5.426806231334513e-07 -0.09085984131838379 -1.0002 0.6907660030966559 0.6907639135807782 5.338282323824606e-07 -0.09086249106798255 -1.0003 0.6907708026605055 0.6907687012468959 5.248511190381056e-07 -0.09086514008618075 -1.0004000000000002 0.6907756007723701 0.6907734876520912 5.15751288079902e-07 -0.09086778837315891 -1.0005 0.690780397431338 0.6907782727979854 5.065307712298628e-07 -0.09087043592909755 -1.0006 0.6907851926365187 0.690783056686179 4.971916262030973e-07 -0.09087308275417726 -1.0007000000000001 0.6907899863870439 0.6907878393182496 4.877359365412781e-07 -0.09087572884857842 -1.0008000000000001 0.6907947786820671 0.6907926206957533 4.781658109187514e-07 -0.09087837421248149 -1.0009000000000001 0.6907995695207637 0.6907974008202237 4.684833828511037e-07 -0.0908810188460669 -1.001 0.6908043589023324 0.690802179693171 4.5869081005678325e-07 -0.090883662749515 -1.0011 0.6908091468259943 0.6908069573160833 4.487902741379113e-07 -0.09088630592300613 -1.0012 0.6908139332909936 0.6908117336904254 4.387839799835369e-07 -0.09088894836672068 -1.0013 0.6908187182965981 0.690816508817638 4.2867415535330355e-07 -0.09089159008083886 -1.0014 0.6908235018420987 0.6908212826991387 4.1846305028764297e-07 -0.09089423106554095 -1.0015 0.6908282839268101 0.6908260553363208 4.0815293674001385e-07 -0.09089687132100714 -1.0016 0.6908330645500713 0.690830826730554 3.9774610789689024e-07 -0.09089951084741765 -1.0017 0.6908378437112451 0.6908355968831829 3.872448778655113e-07 -0.09090214964495255 -1.0018 0.6908426214097196 0.6908403657955282 3.766515809661142e-07 -0.09090478771379211 -1.0019 0.6908473976449062 0.6908451334688852 3.6596857140580585e-07 -0.09090742505411627 -1.002 0.690852172416242 0.6908498999045249 3.5519822257773503e-07 -0.09091006166610517 -1.0021 0.6908569457231888 0.690854665103693 3.443429266586362e-07 -0.0909126975499388 -1.0022 0.690861717565234 0.6908594290676089 3.334050940467792e-07 -0.09091533270579712 -1.0023 0.69086648794189 0.6908641917974678 3.2238715279298e-07 -0.09091796713386013 -1.0024000000000002 0.6908712568526951 0.6908689532944382 3.1129154811487814e-07 -0.0909206008343078 -1.0025 0.6908760242972128 0.6908737135596632 3.001207417516194e-07 -0.09092323380731994 -1.0026 0.6908807902750336 0.6908784725942596 2.8887721156140023e-07 -0.09092586605307647 -1.0027000000000001 0.6908855547857728 0.6908832303993178 2.775634508761504e-07 -0.0909284975717572 -1.0028000000000001 0.6908903178290731 0.6908879869759021 2.6618196800887173e-07 -0.09093112836354195 -1.0029000000000001 0.6908950794046025 0.6908927423250499 2.54735285587504e-07 -0.09093375842861036 -1.003 0.6908998395120565 0.6908974964477725 2.4322594017328614e-07 -0.09093638776714233 -1.0031 0.6909045981511566 0.690902249345054 2.31656481532172e-07 -0.09093901637931746 -1.0032 0.6909093553216518 0.6909070010178513 2.200294721074747e-07 -0.0909416442653155 -1.0033 0.6909141110233173 0.6909117514670944 2.0834748658271618e-07 -0.090944271425316 -1.0034 0.690918865255956 0.6909165006936866 1.9661311114610447e-07 -0.09094689785949862 -1.0035 0.6909236180193977 0.6909212486985028 1.8482894296317776e-07 -0.09094952356804296 -1.0036 0.6909283693134995 0.6909259954823912 1.7299758968414292e-07 -0.09095214855112849 -1.0037 0.6909331191381458 0.6909307410461722 1.611216687708028e-07 -0.09095477280893476 -1.0038 0.6909378674932487 0.6909354853906391 1.492038069449142e-07 -0.09095739634164118 -1.0039 0.6909426143787474 0.6909402285165562 1.3724663962960681e-07 -0.09096001914942722 -1.004 0.6909473597946098 0.6909449704246613 1.2525281035957736e-07 -0.09096264123247236 -1.0041 0.6909521037408306 0.6909497111156637 1.1322497017740574e-07 -0.09096526259095593 -1.0042 0.6909568462174327 0.6909544505902447 1.0116577705762686e-07 -0.09096788322505726 -1.0043 0.690961587224467 0.6909591888490578 8.907789531692467e-08 -0.0909705031349557 -1.0044000000000002 0.6909663267620118 0.6909639258927278 7.696399504861229e-08 -0.09097312232083049 -1.0045 0.6909710648301739 0.6909686617218522 6.482675151721351e-08 -0.09097574078286089 -1.0046 0.6909758014290883 0.6909733963369998 5.266884454437071e-08 -0.09097835852122611 -1.0047000000000001 0.6909805365589178 0.690978129738711 4.049295795720276e-08 -0.09098097553610539 -1.0048000000000001 0.6909852702198535 0.6909828619274982 2.830177895860042e-08 -0.09098359182767785 -1.0049000000000001 0.6909900024121143 0.6909875929038456 1.6097997570380107e-08 -0.0909862073961226 -1.005 0.6909947331359476 0.6909923226682085 3.884306013987593e-09 -0.09098882224161871 -1.0051 0.6909994623916289 0.6909970512210146 -8.336601871501703e-09 -0.09099143636434526 -1.0052 0.6910041901794624 0.6910017785626625 -2.0562031226561278e-08 -0.09099404976448129 -1.0053 0.6910089164997796 0.6910065046935231 -3.278928677272891e-08 -0.09099666244220578 -1.0054 0.6910136413529409 0.6910112296139385 -4.5015673391245355e-08 -0.0909992743976977 -1.0055 0.6910183647393348 0.6910159533242224 -5.723849673096651e-08 -0.09100188563113594 -1.0056 0.6910230866593776 0.6910206758246602 -6.945506379751887e-08 -0.09100449614269943 -1.0057 0.6910278071135145 0.6910253971155091 -8.166268354332235e-08 -0.09100710593256696 -1.0058 0.6910325261022185 0.6910301171969979 -9.385866746487725e-08 -0.09100971500091747 -1.0059 0.6910372436259904 0.6910348360693275 -1.0604033019376291e-07 -0.09101232334792965 -1.006 0.6910419596853592 0.6910395537326698 -1.1820499008427521e-07 -0.09101493097378231 -1.0061 0.6910466742808822 0.6910442701871693 -1.3034996981797775e-07 -0.09101753787865419 -1.0062 0.691051387413145 0.6910489854329418 -1.4247259695621128e-07 -0.09102014406272402 -1.0063 0.6910560990827604 0.6910536994700753 -1.5457020458888027e-07 -0.09102274952617044 -1.0064000000000002 0.6910608092903696 0.6910584122986297 -1.6664013186701299e-07 -0.09102535426917206 -1.0065 0.6910655180366412 0.691063123918637 -1.7867972460644532e-07 -0.09102795829190753 -1.0066 0.6910702253222716 0.6910678343301013 -1.9068633588456563e-07 -0.09103056159455541 -1.0067000000000002 0.6910749311479851 0.6910725435329991 -2.0265732660409985e-07 -0.09103316417729426 -1.0068000000000001 0.6910796355145332 0.6910772515272786 -2.1459006608465225e-07 -0.09103576604030252 -1.0069000000000001 0.6910843384226952 0.6910819583128609 -2.264819326386336e-07 -0.09103836718375868 -1.007 0.6910890398732774 0.6910866638896396 -2.3833031411249483e-07 -0.09104096760784122 -1.0071 0.691093739867114 0.6910913682574809 -2.50132608552861e-07 -0.09104356731272856 -1.0072 0.6910984384050654 0.6910960714162233 -2.6188622467143707e-07 -0.09104616629859902 -1.0073 0.6911031354880195 0.6911007733656784 -2.7358858248338613e-07 -0.09104876456563096 -1.0074 0.6911078311168916 0.6911054741056311 -2.852371138485632e-07 -0.09105136211400272 -1.0075 0.6911125252926229 0.6911101736358389 -2.9682926303009616e-07 -0.09105395894389262 -1.0076 0.6911172180161815 0.6911148719560327 -3.0836248729460003e-07 -0.0910565550554788 -1.0077 0.6911219092885622 0.6911195690659167 -3.198342574187163e-07 -0.09105915044893956 -1.0078 0.691126599110786 0.6911242649651687 -3.312420582615716e-07 -0.09106174512445303 -1.0079 0.6911312874839003 0.69112895965344 -3.4258338932335874e-07 -0.0910643390821974 -1.008 0.691135974408978 0.6911336531303559 -3.5385576530738705e-07 -0.09106693232235076 -1.0081 0.6911406598871185 0.691138345395516 -3.6505671661968275e-07 -0.09106952484509126 -1.0082 0.6911453439194464 0.6911430364484934 -3.7618378997267277e-07 -0.0910721166505969 -1.0083 0.691150026507112 0.6911477262888355 -3.8723454887090725e-07 -0.09107470773904573 -1.0084000000000002 0.6911547076512912 0.6911524149160649 -3.982065741592322e-07 -0.09107729811061571 -1.0085 0.6911593873531847 0.6911571023296785 -4.090974645709622e-07 -0.09107988776548487 -1.0086 0.6911640656140179 0.6911617885291478 -4.199048372274805e-07 -0.09108247670383099 -1.0087000000000002 0.6911687424350417 0.6911664735139199 -4.3062632822110647e-07 -0.09108506492583208 -1.0088000000000001 0.691173417817531 0.691171157283417 -4.4125959301755113e-07 -0.09108765243166599 -1.0089000000000001 0.6911780917627854 0.6911758398370368 -4.518023070873567e-07 -0.09109023922151051 -1.009 0.6911827642721279 0.6911805211741529 -4.62252166329169e-07 -0.09109282529554344 -1.0091 0.6911874353469063 0.6911852012941145 -4.7260688759709346e-07 -0.09109541065394257 -1.0092 0.6911921049884917 0.6911898801962473 -4.828642092766233e-07 -0.09109799529688559 -1.0093 0.6911967731982787 0.6911945578798531 -4.930218916454621e-07 -0.0911005792245503 -1.0094 0.6912014399776849 0.6911992343442103 -5.030777174633294e-07 -0.0911031624371142 -1.0095 0.6912061053281515 0.6912039095885745 -5.130294924368672e-07 -0.0911057449347551 -1.0096 0.6912107692511416 0.6912085836121784 -5.228750456429121e-07 -0.09110832671765047 -1.0097 0.691215431748141 0.6912132564142318 -5.326122300766678e-07 -0.09111090778597797 -1.0098 0.6912200928206584 0.6912179279939223 -5.422389231096725e-07 -0.0911134881399151 -1.0099 0.6912247524702237 0.6912225983504151 -5.517530269061321e-07 -0.09111606777963932 -1.01 0.691229410698389 0.6912272674828541 -5.611524689502767e-07 -0.09111864670532818 -1.0101 0.6912340675067272 0.6912319353903611 -5.704352023794268e-07 -0.09112122491715909 -1.0102 0.6912387228968332 0.6912366020720366 -5.79599206559922e-07 -0.09112380241530942 -1.0103 0.6912433768703221 0.6912412675269608 -5.886424874618212e-07 -0.09112637919995661 -1.0104000000000002 0.6912480294288297 0.6912459317541924 -5.975630781307473e-07 -0.091128955271278 -1.0105 0.6912526805740122 0.6912505947527697 -6.063590390348317e-07 -0.09113153062945084 -1.0106 0.6912573303075462 0.6912552565217112 -6.150284586059485e-07 -0.09113410527465243 -1.0107000000000002 0.6912619786311271 0.6912599170600149 -6.235694535311476e-07 -0.09113667920706003 -1.0108000000000001 0.6912666255464712 0.6912645763666603 -6.31980169335522e-07 -0.0911392524268509 -1.0109000000000001 0.6912712710553122 0.6912692344406067 -6.40258780576497e-07 -0.09114182493420218 -1.011 0.6912759151594035 0.6912738912807949 -6.484034913295522e-07 -0.091144396729291 -1.0111 0.691280557860517 0.6912785468861469 -6.56412535660067e-07 -0.09114696781229452 -1.0112 0.6912851991604423 0.6912832012555661 -6.642841779147535e-07 -0.09114953818338974 -1.0113 0.6912898390609874 0.6912878543879386 -6.720167131379906e-07 -0.0911521078427538 -1.0114 0.6912944775639775 0.6912925062821325 -6.796084673493796e-07 -0.0911546767905637 -1.0115 0.6912991146712553 0.6912971569369982 -6.870577980017112e-07 -0.0911572450269964 -1.0116 0.6913037503846797 0.6913018063513697 -6.943630944111767e-07 -0.09115981255222888 -1.0117 0.691308384706127 0.6913064545240637 -7.015227778961464e-07 -0.09116237936643805 -1.0118 0.6913130176374889 0.6913111014538814 -7.085353022906471e-07 -0.0911649454698008 -1.0119 0.6913176491806732 0.6913157471396072 -7.153991542357963e-07 -0.09116751086249397 -1.012 0.6913222793376035 0.6913203915800104 -7.221128534573573e-07 -0.09117007554469445 -1.0121 0.6913269081102181 0.6913250347738447 -7.286749531126846e-07 -0.091172639516579 -1.0122 0.6913315355004703 0.6913296767198491 -7.350840401654235e-07 -0.09117520277832437 -1.0123 0.6913361615103277 0.6913343174167479 -7.413387355797996e-07 -0.09117776533010732 -1.0124000000000002 0.6913407861417722 0.6913389568632509 -7.474376947508299e-07 -0.09118032717210449 -1.0125 0.6913454093967987 0.6913435950580546 -7.53379607643101e-07 -0.09118288830449256 -1.0126 0.6913500312774163 0.6913482319998421 -7.591631991793468e-07 -0.09118544872744819 -1.0127000000000002 0.6913546517856464 0.6913528676872827 -7.647872294902491e-07 -0.0911880084411479 -1.0128000000000001 0.6913592709235239 0.6913575021190332 -7.702504941642374e-07 -0.09119056744576835 -1.0129000000000001 0.6913638886930948 0.6913621352937387 -7.755518245250448e-07 -0.09119312574148608 -1.013 0.6913685050964179 0.6913667672100314 -7.80690087895386e-07 -0.09119568332847756 -1.0131000000000001 0.6913731201355624 0.6913713978665325 -7.85664187805124e-07 -0.09119824020691925 -1.0132 0.6913777338126095 0.6913760272618514 -7.904730642133151e-07 -0.09120079637698758 -1.0133 0.6913823461296509 0.6913806553945872 -7.951156937441306e-07 -0.09120335183885897 -1.0134 0.6913869570887881 0.6913852822633287 -7.995910900199243e-07 -0.09120590659270982 -1.0135 0.6913915666921331 0.6913899078666539 -8.038983036473546e-07 -0.0912084606387164 -1.0136 0.6913961749418072 0.6913945322031316 -8.080364226614734e-07 -0.0912110139770551 -1.0137 0.6914007818399405 0.6913991552713215 -8.120045725257263e-07 -0.0912135666079021 -1.0138 0.6914053873886724 0.6914037770697739 -8.158019164927754e-07 -0.09121611853143374 -1.0139 0.6914099915901505 0.6914083975970311 -8.194276556044988e-07 -0.0912186697478262 -1.014 0.6914145944465295 0.6914130168516268 -8.228810288862798e-07 -0.09122122025725557 -1.0141 0.6914191959599733 0.6914176348320881 -8.261613136523183e-07 -0.09122377005989815 -1.0142 0.691423796132651 0.6914222515369335 -8.292678256027752e-07 -0.09122631915592996 -1.0143 0.6914283949667401 0.6914268669646753 -8.321999188376505e-07 -0.0912288675455271 -1.0144000000000002 0.6914329924644232 0.6914314811138191 -8.349569861482165e-07 -0.09123141522886558 -1.0145 0.6914375886278896 0.691436093982865 -8.375384589753843e-07 -0.0912339622061215 -1.0146 0.6914421834593337 0.6914407055703066 -8.399438077844046e-07 -0.09123650847747077 -1.0147 0.6914467769609551 0.6914453158746329 -8.421725419538451e-07 -0.09123905404308938 -1.0148000000000001 0.6914513691349577 0.6914499248943277 -8.442242098727348e-07 -0.0912415989031532 -1.0149000000000001 0.6914559599835506 0.6914545326278709 -8.460983992736315e-07 -0.09124414305783819 -1.015 0.6914605495089458 0.6914591390737376 -8.477947369550654e-07 -0.09124668650732014 -1.0151000000000001 0.6914651377133592 0.6914637442304 -8.493128891839952e-07 -0.09124922925177492 -1.0152 0.6914697245990099 0.6914683480963268 -8.506525615015192e-07 -0.09125177129137832 -1.0153 0.6914743101681191 0.6914729506699838 -8.518134990836979e-07 -0.09125431262630604 -1.0154 0.6914788944229106 0.6914775519498348 -8.527954865056309e-07 -0.09125685325673384 -1.0155 0.69148347736561 0.6914821519343417 -8.535983477553355e-07 -0.09125939318283746 -1.0156 0.6914880589984438 0.6914867506219644 -8.542219466362022e-07 -0.09126193240479251 -1.0157 0.6914926393236401 0.691491348011162 -8.546661864061722e-07 -0.09126447092277457 -1.0158 0.6914972183434271 0.6914959441003928 -8.549310099442708e-07 -0.09126700873695932 -1.0159 0.6915017960600331 0.6915005388881151 -8.550163997089744e-07 -0.09126954584752225 -1.016 0.6915063724756866 0.6915051323727874 -8.549223778769877e-07 -0.09127208225463901 -1.0161 0.6915109475926147 0.6915097245528683 -8.546490061489553e-07 -0.09127461795848497 -1.0162 0.6915155214130436 0.6915143154268175 -8.541963857772172e-07 -0.09127715295923565 -1.0163 0.6915200939391986 0.6915189049930963 -8.535646576768308e-07 -0.09127968725706649 -1.0164000000000002 0.691524665173302 0.6915234932501678 -8.527540021341373e-07 -0.09128222085215289 -1.0165 0.6915292351175746 0.691528080196497 -8.517646388483957e-07 -0.09128475374467017 -1.0166 0.6915338037742337 0.6915326658305518 -8.505968271260711e-07 -0.0912872859347937 -1.0167 0.6915383711454941 0.6915372501508033 -8.492508654506237e-07 -0.0912898174226988 -1.0168000000000001 0.6915429372335664 0.6915418331557256 -8.477270916906754e-07 -0.09129234820856072 -1.0169000000000001 0.6915475020406575 0.6915464148437973 -8.460258826836764e-07 -0.0912948782925547 -1.017 0.6915520655689699 0.6915509952135007 -8.441476545828497e-07 -0.09129740767485596 -1.0171000000000001 0.6915566278207008 0.6915555742633231 -8.420928623992241e-07 -0.09129993635563965 -1.0172 0.6915611887980428 0.6915601519917571 -8.398620000432677e-07 -0.09130246433508099 -1.0173 0.6915657485031824 0.6915647283973001 -8.374556002138656e-07 -0.09130499161335497 -1.0174 0.6915703069383001 0.6915693034784558 -8.348742342734194e-07 -0.0913075181906367 -1.0175 0.6915748641055701 0.691573877233735 -8.321185120119257e-07 -0.09131004406710133 -1.0176 0.6915794200071596 0.6915784496616538 -8.291890817024861e-07 -0.09131256924292372 -1.0177 0.6915839746452284 0.6915830207607363 -8.260866296572189e-07 -0.09131509371827892 -1.0178 0.6915885280219287 0.6915875905295142 -8.228118803799145e-07 -0.09131761749334188 -1.0179 0.6915930801394048 0.6915921589665267 -8.193655961774571e-07 -0.09132014056828751 -1.018 0.6915976309997924 0.6915967260703216 -8.157485771320694e-07 -0.09132266294329071 -1.0181 0.6916021806052184 0.6916012918394552 -8.119616607821234e-07 -0.09132518461852628 -1.0182 0.6916067289578003 0.6916058562724932 -8.080057220388737e-07 -0.09132770559416906 -1.0183 0.6916112760596461 0.6916104193680107 -8.038816729227793e-07 -0.09133022587039391 -1.0184000000000002 0.6916158219128536 0.6916149811245924 -7.995904623692152e-07 -0.09133274544737546 -1.0185 0.6916203665195105 0.6916195415408335 -7.951330761035713e-07 -0.0913352643252885 -1.0186 0.6916249098816933 0.6916241006153399 -7.905105362665532e-07 -0.09133778250430771 -1.0187 0.6916294520014674 0.6916286583467284 -7.857239011505035e-07 -0.09134029998460774 -1.0188000000000001 0.691633992880887 0.6916332147336273 -7.807742651577687e-07 -0.09134281676636319 -1.0189000000000001 0.6916385325219936 0.6916377697746768 -7.756627585092657e-07 -0.09134533284974866 -1.019 0.6916430709268175 0.6916423234685294 -7.703905468142702e-07 -0.09134784823493874 -1.0191000000000001 0.6916476080973752 0.6916468758138494 -7.649588309038835e-07 -0.09135036292210796 -1.0192 0.6916521440356707 0.691651426809315 -7.593688467061321e-07 -0.09135287691143076 -1.0193 0.6916566787436947 0.6916559764536168 -7.536218646908566e-07 -0.09135539020308166 -1.0194 0.6916612122234236 0.6916605247454592 -7.477191898141999e-07 -0.091357902797235 -1.0195 0.6916657444768204 0.6916650716835614 -7.416621610190077e-07 -0.09136041469406526 -1.0196 0.6916702755058329 0.6916696172666559 -7.35452151151561e-07 -0.09136292589374678 -1.0197 0.6916748053123944 0.6916741614934903 -7.290905665174874e-07 -0.09136543639645386 -1.0198 0.6916793338984234 0.6916787043628274 -7.225788465764493e-07 -0.09136794620236088 -1.0199 0.6916838612658218 0.6916832458734452 -7.159184636923444e-07 -0.09137045531164201 -1.02 0.6916883874164765 0.6916877860241373 -7.091109226753378e-07 -0.0913729637244715 -1.0201 0.6916929123522582 0.6916923248137138 -7.021577604349183e-07 -0.0913754714410236 -1.0202 0.6916974360750202 0.6916968622410008 -6.950605459105086e-07 -0.09137797846147244 -1.0203 0.6917019585865999 0.6917013983048416 -6.878208793775764e-07 -0.0913804847859922 -1.0204000000000002 0.6917064798888168 0.6917059330040958 -6.804403922533453e-07 -0.09138299041475692 -1.0205 0.6917109999834737 0.6917104663376412 -6.729207467359721e-07 -0.09138549534794073 -1.0206 0.6917155188723545 0.6917149983043727 -6.652636352633134e-07 -0.09138799958571764 -1.0207 0.6917200365572256 0.6917195289032037 -6.574707805545588e-07 -0.09139050312826169 -1.0208000000000002 0.6917245530398347 0.6917240581330653 -6.495439346387855e-07 -0.09139300597574679 -1.0209000000000001 0.6917290683219106 0.6917285859929079 -6.414848789104699e-07 -0.0913955081283469 -1.021 0.6917335824051634 0.6917331124817006 -6.332954235188648e-07 -0.09139800958623595 -1.0211000000000001 0.6917380952912835 0.6917376375984317 -6.249774071043213e-07 -0.09140051034958785 -1.0212 0.6917426069819415 0.6917421613421086 -6.165326962292994e-07 -0.09140301041857635 -1.0213 0.6917471174787884 0.6917466837117598 -6.079631850869349e-07 -0.09140550979337533 -1.0214 0.6917516267834547 0.6917512047064328 -5.992707949598053e-07 -0.09140800847415861 -1.0215 0.6917561348975503 0.6917557243251956 -5.904574739284962e-07 -0.09141050646109986 -1.0216 0.6917606418226644 0.691760242567137 -5.81525196399757e-07 -0.09141300375437278 -1.0217 0.691765147560365 0.6917647594313672 -5.724759624681219e-07 -0.09141550035415111 -1.0218 0.6917696521121991 0.6917692749170166 -5.633117977632551e-07 -0.09141799626060845 -1.0219 0.6917741554796917 0.6917737890232383 -5.540347528532052e-07 -0.0914204914739185 -1.022 0.6917786576643459 0.6917783017492061 -5.446469027586831e-07 -0.09142298599425476 -1.0221 0.6917831586676431 0.6917828130941165 -5.351503465228502e-07 -0.09142547982179085 -1.0222 0.6917876584910416 0.6917873230571876 -5.255472068504963e-07 -0.09142797295670022 -1.0223 0.6917921571359779 0.6917918316376603 -5.158396293586387e-07 -0.09143046539915639 -1.0224000000000002 0.6917966546038646 0.6917963388347985 -5.060297824308058e-07 -0.09143295714933275 -1.0225 0.6918011508960926 0.6918008446478885 -4.96119856474575e-07 -0.09143544820740285 -1.0226 0.6918056460140285 0.6918053490762401 -4.861120635954452e-07 -0.09143793857354002 -1.0227 0.6918101399590157 0.6918098521191864 -4.7600863699315266e-07 -0.0914404282479176 -1.0228000000000002 0.6918146327323735 0.6918143537760841 -4.6581183055227626e-07 -0.09144291723070894 -1.0229000000000001 0.6918191243353974 0.6918188540463139 -4.555239182454929e-07 -0.09144540552208733 -1.023 0.6918236147693588 0.6918233529292802 -4.451471937588769e-07 -0.09144789312222601 -1.0231000000000001 0.691828104035505 0.691827850424412 -4.3468396979801094e-07 -0.09145038003129827 -1.0232 0.6918325921350581 0.6918323465311622 -4.2413657776879665e-07 -0.09145286624947721 -1.0233 0.6918370790692158 0.691836841249009 -4.1350736711132097e-07 -0.09145535177693603 -1.0234 0.6918415648391507 0.6918413345774549 -4.02798704911278e-07 -0.09145783661384788 -1.0235 0.6918460494460108 0.6918458265160277 -3.920129752060797e-07 -0.09146032076038589 -1.0236 0.6918505328909178 0.6918503170642799 -3.811525785893388e-07 -0.09146280421672304 -1.0237 0.6918550151749687 0.6918548062217897 -3.7021993162106304e-07 -0.09146528698303241 -1.0238 0.6918594962992348 0.6918592939881608 -3.5921746628642115e-07 -0.09146776905948699 -1.0239 0.6918639762647613 0.6918637803630225 -3.481476295377761e-07 -0.09147025044625974 -1.024 0.6918684550725676 0.6918682653460297 -3.3701288259385676e-07 -0.09147273114352361 -1.0241000000000002 0.6918729327236472 0.6918727489368635 -3.2581570050954634e-07 -0.09147521115145153 -1.0242 0.6918774092189672 0.691877231135231 -3.1455857160689327e-07 -0.09147769047021637 -1.0243 0.6918818845594683 0.6918817119408653 -3.0324399697551074e-07 -0.09148016909999089 -1.0244000000000002 0.6918863587460642 0.6918861913535261 -2.91874489737054e-07 -0.09148264704094794 -1.0245 0.6918908317796434 0.6918906693729996 -2.8045257469133666e-07 -0.09148512429326033 -1.0246000000000002 0.6918953036610662 0.6918951459990983 -2.689807876675443e-07 -0.09148760085710075 -1.0247 0.691899774391167 0.6918996212316617 -2.5746167489626437e-07 -0.09149007673264195 -1.0248 0.6919042439707528 0.6919040950705557 -2.458977926139694e-07 -0.09149255192005656 -1.0249000000000001 0.6919087124006034 0.6919085675156734 -2.3429170632749408e-07 -0.09149502641951722 -1.025 0.6919131796814719 0.6919130385669351 -2.22645990321374e-07 -0.09149750023119656 -1.0251000000000001 0.6919176458140843 0.6919175082242877 -2.1096322708885618e-07 -0.09149997335526718 -1.0252000000000001 0.6919221107991389 0.6919219764877056 -1.9924600675944037e-07 -0.09150244579190162 -1.0252999999999999 0.6919265746373066 0.6919264433571901 -1.8749692649519534e-07 -0.09150491754127238 -1.0254 0.6919310373292309 0.6919309088327703 -1.7571858994952505e-07 -0.09150738860355195 -1.0255 0.6919354988755282 0.6919353729145021 -1.6391360666348498e-07 -0.09150985897891278 -1.0256 0.6919399592767868 0.6919398356024691 -1.5208459152628306e-07 -0.09151232866752729 -1.0257 0.6919444185335677 0.6919442968967824 -1.4023416414210566e-07 -0.09151479766956784 -1.0258 0.6919488766464041 0.6919487567975804 -1.28364948275006e-07 -0.09151726598520682 -1.0259 0.6919533336158017 0.6919532153050293 -1.1647957130246633e-07 -0.09151973361461652 -1.026 0.6919577894422381 0.6919576724193226 -1.0458066357701967e-07 -0.09152220055796921 -1.0261000000000002 0.6919622441261635 0.6919621281406818 -9.267085787981189e-08 -0.0915246668154372 -1.0262 0.6919666976680001 0.6919665824693557 -8.075278882732628e-08 -0.09152713238719264 -1.0263 0.6919711500681424 0.6919710354056208 -6.882909228851652e-08 -0.09152959727340777 -1.0264000000000002 0.6919756013269573 0.6919754869497812 -5.6902404802806894e-08 -0.09153206147425474 -1.0265 0.6919800514447836 0.6919799371021684 -4.497536300156202e-08 -0.09153452498990562 -1.0266000000000002 0.6919845004219322 0.6919843858631428 -3.30506030194193e-08 -0.09153698782053256 -1.0267 0.6919889482586867 0.6919888332330909 -2.113075991158446e-08 -0.09153944996630764 -1.0268 0.6919933949553029 0.6919932792124273 -9.21846707432547e-09 -0.09154191142740281 -1.0269000000000001 0.6919978405120084 0.6919977238015943 2.683644338002944e-09 -0.0915443722039901 -1.027 0.6920022849290031 0.6920021670010621 1.4572945996639552e-08 -0.09154683229624146 -1.0271000000000001 0.6920067282064599 0.6920066088113279 2.644681296876117e-08 -0.09154929170432888 -1.0272000000000001 0.6920111703445233 0.6920110492329167 3.830262430490339e-08 -0.09155175042842417 -1.0272999999999999 0.692015611343311 0.6920154882663805 5.013776363006761e-08 -0.09155420846869926 -1.0274 0.6920200512029122 0.6920199259122993 6.194961968929158e-08 -0.09155666582532594 -1.0275 0.6920244899233894 0.6920243621712799 7.37355869591394e-08 -0.09155912249847603 -1.0276 0.6920289275047775 0.6920287970439567 8.549306619587416e-08 -0.09156157848832128 -1.0277 0.6920333639470837 0.6920332305309913 9.721946502352918e-08 -0.09156403379503346 -1.0278 0.6920377992502887 0.6920376626330722 1.0891219849248901e-07 -0.09156648841878427 -1.0279 0.6920422334143455 0.6920420933509148 1.2056868967449952e-07 -0.09156894235974536 -1.028 0.6920466664391793 0.6920465226852617 1.3218637021084056e-07 -0.0915713956180883 -1.0281000000000002 0.6920510983246901 0.692050950636882 1.4376268089172362e-07 -0.09157384819398476 -1.0282 0.69205552907075 0.6920553772065723 1.5529507215936156e-07 -0.09157630008760637 -1.0283 0.6920599586772038 0.6920598023951551 1.6678100477410251e-07 -0.09157875129912457 -1.0284 0.6920643871438703 0.6920642262034793 1.782179503070913e-07 -0.09158120182871088 -1.0285 0.692068814470542 0.6920686486324211 1.8960339169885043e-07 -0.09158365167653681 -1.0286000000000002 0.6920732406569842 0.6920730696828821 2.0093482385255546e-07 -0.0915861008427738 -1.0287 0.6920776657029368 0.6920774893557905 2.1220975411628817e-07 -0.09158854932759329 -1.0288 0.6920820896081126 0.6920819076521003 2.234257029179454e-07 -0.09159099713116658 -1.0289000000000001 0.6920865123721989 0.6920863245727913 2.3458020424055315e-07 -0.09159344425366504 -1.029 0.6920909339948573 0.6920907401188692 2.4567080618431714e-07 -0.09159589069525997 -1.0291000000000001 0.6920953544757236 0.6920951542913651 2.5669507152520366e-07 -0.0915983364561227 -1.0292000000000001 0.6920997738144081 0.6920995670913359 2.6765057823535665e-07 -0.0916007815364245 -1.0292999999999999 0.6921041920104951 0.6921039785198628 2.7853492003820923e-07 -0.09160322593633646 -1.0294 0.6921086090635444 0.6921083885780533 2.8934570688726735e-07 -0.09160566965602986 -1.0295 0.6921130249730909 0.692112797267039 3.000805655142824e-07 -0.09160811269567587 -1.0296 0.6921174397386436 0.6921172045879762 3.107371399843628e-07 -0.0916105550554455 -1.0297 0.6921218533596879 0.6921216105420458 3.2131309218169646e-07 -0.09161299673550989 -1.0298 0.6921262658356844 0.6921260151304535 3.318061023091512e-07 -0.09161543773604015 -1.0299 0.6921306771660692 0.6921304183544282 3.4221386945726406e-07 -0.09161787805720722 -1.03 0.6921350873502545 0.6921348202152238 3.5253411201363605e-07 -0.09162031769918211 -1.0301000000000002 0.6921394963876288 0.692139220714117 3.6276456825273806e-07 -0.09162275666213576 -1.0302 0.6921439042775566 0.6921436198524085 3.7290299680775574e-07 -0.0916251949462391 -1.0303 0.6921483110193793 0.6921480176314221 3.8294717711467863e-07 -0.09162763255166305 -1.0304 0.6921527166124147 0.6921524140525047 3.9289490995353393e-07 -0.09163006947857842 -1.0305 0.6921571210559583 0.6921568091170265 4.027440179202313e-07 -0.09163250572715612 -1.0306000000000002 0.692161524349282 0.6921612028263794 4.1249234589146866e-07 -0.09163494129756683 -1.0307 0.6921659264916358 0.6921655951819783 4.22137761503516e-07 -0.09163737618998138 -1.0308 0.6921703274822473 0.6921699861852595 4.316781556171212e-07 -0.09163981040457048 -1.0309000000000001 0.6921747273203218 0.6921743758376824 4.411114427615992e-07 -0.0916422439415048 -1.031 0.6921791260050434 0.6921787641407267 4.5043556162749354e-07 -0.09164467680095502 -1.0311000000000001 0.6921835235355744 0.6921831510958945 4.596484754898489e-07 -0.09164710898309181 -1.0312000000000001 0.6921879199110559 0.6921875367047082 4.6874817270781133e-07 -0.09164954048808571 -1.0312999999999999 0.6921923151306077 0.6921919209687115 4.777326670091231e-07 -0.09165197131610732 -1.0314 0.6921967091933295 0.6921963038894685 4.865999981840119e-07 -0.0916544014673272 -1.0315 0.6922011020983001 0.6922006854685636 4.953482322378466e-07 -0.09165683094191579 -1.0316 0.6922054938445784 0.6922050657076011 5.039754619601267e-07 -0.09165925974004357 -1.0317 0.6922098844312035 0.6922094446082052 5.124798073824488e-07 -0.09166168786188103 -1.0318 0.6922142738571944 0.692213822172019 5.208594160838187e-07 -0.09166411530759848 -1.0319 0.6922186621215516 0.6922181984007053 5.291124636902511e-07 -0.09166654207736633 -1.032 0.6922230492232562 0.6922225732959455 5.372371541106924e-07 -0.0916689681713549 -1.0321000000000002 0.6922274351612707 0.6922269468594398 5.452317201337653e-07 -0.09167139358973457 -1.0322 0.6922318199345394 0.6922313190929059 5.530944236636914e-07 -0.09167381833267552 -1.0323 0.692236203541988 0.6922356899980803 5.608235561643804e-07 -0.09167624240034804 -1.0324 0.6922405859825252 0.6922400595767162 5.684174390341301e-07 -0.09167866579292228 -1.0325 0.692244967255042 0.6922444278305846 5.758744239803271e-07 -0.09168108851056846 -1.0326000000000002 0.6922493473584121 0.6922487947614737 5.831928932692465e-07 -0.09168351055345673 -1.0327 0.6922537262914927 0.6922531603711879 5.903712602395306e-07 -0.09168593192175721 -1.0328 0.6922581040531245 0.6922575246615477 5.974079695658663e-07 -0.09168835261563996 -1.0329000000000002 0.6922624806421318 0.69226188763439 6.043014975226635e-07 -0.09169077263527502 -1.033 0.6922668560573237 0.6922662492915671 6.110503524281441e-07 -0.09169319198083241 -1.0331000000000001 0.6922712302974935 0.6922706096349465 6.176530749912867e-07 -0.0916956106524821 -1.0332000000000001 0.6922756033614191 0.6922749686664111 6.241082384644825e-07 -0.09169802865039402 -1.0332999999999999 0.6922799752478643 0.6922793263878579 6.304144491292574e-07 -0.09170044597473814 -1.0334 0.6922843459555783 0.6922836828011983 6.365703465321948e-07 -0.09170286262568429 -1.0335 0.6922887154832962 0.6922880379083576 6.425746037069802e-07 -0.09170527860340237 -1.0336 0.6922930838297392 0.6922923917112744 6.484259276046123e-07 -0.09170769390806213 -1.0337 0.6922974509936155 0.6922967442119012 6.541230592599367e-07 -0.09171010853983341 -1.0338 0.6923018169736201 0.6923010954122024 6.596647740414463e-07 -0.09171252249888591 -1.0339 0.6923061817684355 0.6923054453141555 6.650498820398587e-07 -0.09171493578538939 -1.034 0.6923105453767321 0.6923097939197497 6.702772281652614e-07 -0.09171734839951351 -1.0341000000000002 0.6923149077971684 0.6923141412309861 6.753456925634449e-07 -0.09171976034142797 -1.0342 0.6923192690283917 0.6923184872498773 6.802541907963144e-07 -0.09172217161130236 -1.0343 0.6923236290690372 0.6923228319784467 6.850016740223008e-07 -0.09172458220930632 -1.0344 0.6923279879177304 0.692327175418728 6.89587129232283e-07 -0.09172699213560935 -1.0345 0.6923323455730858 0.6923315175727656 6.940095795132661e-07 -0.091729401390381 -1.0346000000000002 0.6923367020337082 0.6923358584426131 6.982680842010369e-07 -0.09173180997379071 -1.0347 0.6923410572981931 0.6923401980303345 7.023617391160863e-07 -0.09173421788600802 -1.0348 0.692345411365126 0.6923445363380022 7.062896768134097e-07 -0.09173662512720235 -1.0349000000000002 0.6923497642330845 0.692348873367697 7.1005106662414e-07 -0.09173903169754304 -1.035 0.6923541159006369 0.6923532091215087 7.136451149747369e-07 -0.09174143759719948 -1.0351000000000001 0.6923584663663441 0.6923575436015343 7.17071065525765e-07 -0.09174384282634099 -1.0352000000000001 0.6923628156287591 0.6923618768098792 7.203281991441379e-07 -0.09174624738513687 -1.0352999999999999 0.6923671636864276 0.6923662087486548 7.234158343610853e-07 -0.09174865127375637 -1.0354 0.6923715105378887 0.6923705394199803 7.263333272750083e-07 -0.0917510544923688 -1.0355 0.6923758561816746 0.6923748688259801 7.29080071815158e-07 -0.09175345704114324 -1.0356 0.6923802006163121 0.6923791969687856 7.31655499852657e-07 -0.09175585892024894 -1.0357 0.6923845438403218 0.6923835238505329 7.340590812143777e-07 -0.09175826012985504 -1.0358 0.6923888858522191 0.6923878494733634 7.362903239466201e-07 -0.09176066067013057 -1.0359 0.6923932266505148 0.6923921738394235 7.383487743289896e-07 -0.09176306054124467 -1.036 0.6923975662337152 0.6923964969508638 7.402340169299082e-07 -0.09176545974336639 -1.0361000000000002 0.692401904600322 0.6924008188098383 7.419456747453923e-07 -0.09176785827666466 -1.0362 0.6924062417488341 0.6924051394185052 7.434834093239528e-07 -0.09177025614130845 -1.0363 0.6924105776777467 0.6924094587790257 7.448469207804731e-07 -0.09177265333746679 -1.0364 0.6924149123855524 0.692413776893563 7.460359477545753e-07 -0.09177504986530854 -1.0365 0.692419245870741 0.6924180937642835 7.470502676881763e-07 -0.09177744572500258 -1.0366000000000002 0.6924235781318007 0.6924224093933548 7.478896965756876e-07 -0.09177984091671779 -1.0367 0.6924279091672176 0.6924267237829461 7.485540892832043e-07 -0.0917822354406229 -1.0368 0.6924322389754773 0.6924310369352279 7.490433394652385e-07 -0.09178462929688674 -1.0369000000000002 0.6924365675550639 0.6924353488523709 7.493573794675745e-07 -0.091787022485678 -1.037 0.6924408949044615 0.6924396595365465 7.494961804521694e-07 -0.09178941500716545 -1.0371000000000001 0.6924452210221543 0.692443968989926 7.494597524387858e-07 -0.09179180686151778 -1.0372000000000001 0.6924495459066267 0.6924482772146796 7.492481441245813e-07 -0.0917941980489036 -1.0372999999999999 0.6924538695563638 0.6924525842129768 7.488614430228857e-07 -0.09179658856949154 -1.0374 0.6924581919698523 0.6924568899869857 7.482997754215681e-07 -0.09179897842345017 -1.0375 0.6924625131455805 0.6924611945388726 7.475633062165032e-07 -0.09180136761094804 -1.0376 0.6924668330820389 0.6924654978708014 7.46652239078105e-07 -0.0918037561321537 -1.0377 0.6924711517777201 0.6924697999849337 7.455668161043816e-07 -0.09180614398723562 -1.0378 0.6924754692311197 0.692474100883428 7.443073180984916e-07 -0.09180853117636223 -1.0379 0.6924797854407363 0.6924784005684391 7.428740642356768e-07 -0.09181091769970195 -1.038 0.6924841004050732 0.6924826990421185 7.412674121187734e-07 -0.09181330355742322 -1.0381000000000002 0.6924884141226365 0.6924869963066128 7.394877576810677e-07 -0.09181568874969435 -1.0382 0.6924927265919375 0.6924912923640647 7.375355349920065e-07 -0.09181807327668368 -1.0383 0.6924970378114923 0.692495587216611 7.354112162849535e-07 -0.09182045713855946 -1.0384 0.6925013477798223 0.6924998808663838 7.331153117073885e-07 -0.09182284033548997 -1.0385 0.6925056564954544 0.6925041733155093 7.306483693902965e-07 -0.09182522286764346 -1.0386000000000002 0.6925099639569217 0.6925084645661069 7.280109750734676e-07 -0.0918276047351881 -1.0387 0.692514270162764 0.69251275462029 7.252037522165189e-07 -0.09182998593829206 -1.0388 0.6925185751115277 0.6925170434801649 7.222273616935837e-07 -0.0918323664771235 -1.0389000000000002 0.6925228788017663 0.69252133114783 7.190825016406555e-07 -0.09183474635185046 -1.039 0.6925271812320417 0.6925256176253765 7.157699073723212e-07 -0.09183712556264104 -1.0391000000000001 0.6925314824009228 0.6925299029148866 7.122903511874723e-07 -0.09183950410966324 -1.0392000000000001 0.6925357823069878 0.6925341870184349 7.086446421472603e-07 -0.09184188199308507 -1.0393 0.692540080948823 0.6925384699380865 7.04833625977952e-07 -0.09184425921307449 -1.0394 0.6925443783250249 0.6925427516758974 7.008581847378625e-07 -0.09184663576979946 -1.0395 0.6925486744341985 0.6925470322339133 6.967192367202113e-07 -0.09184901166342785 -1.0396 0.6925529692749595 0.6925513116141708 6.924177361755657e-07 -0.09185138689412757 -1.0397 0.6925572628459337 0.6925555898186947 6.879546732563302e-07 -0.09185376146206642 -1.0398 0.6925615551457572 0.6925598668495001 6.833310735587794e-07 -0.0918561353674122 -1.0399 0.692565846173078 0.69256414270859 6.785479979704023e-07 -0.09185850861033268 -1.04 0.692570135926555 0.6925684173979565 6.736065425311244e-07 -0.0918608811909956 -1.0401000000000002 0.6925744244048591 0.6925726909195795 6.685078380586074e-07 -0.09186325310956867 -1.0402 0.6925787116066731 0.6925769632754264 6.632530500233491e-07 -0.09186562436621956 -1.0403 0.6925829975306927 0.6925812344674521 6.578433781045945e-07 -0.09186799496111593 -1.0404 0.6925872821756267 0.6925855044975985 6.522800559682906e-07 -0.0918703648944254 -1.0405 0.6925915655401964 0.6925897733677935 6.465643511283092e-07 -0.09187273416631547 -1.0406000000000002 0.6925958476231375 0.6925940410799523 6.406975645301127e-07 -0.09187510277695377 -1.0407 0.6926001284231991 0.6925983076359747 6.346810302870765e-07 -0.09187747072650773 -1.0408 0.6926044079391449 0.6926025730377474 6.285161153196661e-07 -0.09187983801514489 -1.0409000000000002 0.6926086861697531 0.6926068372871416 6.222042191889043e-07 -0.09188220464303269 -1.041 0.6926129631138171 0.6926111003860131 6.157467736522815e-07 -0.09188457061033854 -1.0411000000000001 0.6926172387701457 0.6926153623362028 6.091452423584442e-07 -0.0918869359172298 -1.0412000000000001 0.6926215131375626 0.6926196231395352 6.0240112056964e-07 -0.0918893005638738 -1.0413 0.6926257862149083 0.6926238827978193 5.955159347870165e-07 -0.09189166455043792 -1.0414 0.6926300580010395 0.6926281413128472 5.884912423897992e-07 -0.09189402787708939 -1.0415 0.6926343284948291 0.6926323986863947 5.813286313022248e-07 -0.09189639054399548 -1.0416 0.6926385976951674 0.6926366549202196 5.740297197298627e-07 -0.0918987525513234 -1.0417 0.6926428656009618 0.6926409100160635 5.665961554934817e-07 -0.09190111389924033 -1.0418 0.6926471322111374 0.6926451639756495 5.590296161539499e-07 -0.0919034745879135 -1.0419 0.6926513975246367 0.6926494168006824 5.513318080963003e-07 -0.09190583461750991 -1.042 0.6926556615404209 0.6926536684928495 5.435044665574873e-07 -0.09190819398819672 -1.0421 0.6926599242574694 0.6926579190538189 5.355493550296409e-07 -0.09191055270014098 -1.0422 0.6926641856747808 0.6926621684852399 5.27468264871489e-07 -0.0919129107535097 -1.0423 0.6926684457913723 0.6926664167887426 5.192630149891686e-07 -0.09191526814846984 -1.0424 0.6926727046062806 0.6926706639659379 5.109354513643805e-07 -0.09191762488518841 -1.0425 0.692676962118562 0.6926749100184162 5.024874466658114e-07 -0.09191998096383233 -1.0426000000000002 0.6926812183272929 0.6926791549477487 4.93920899860556e-07 -0.09192233638456847 -1.0427 0.6926854732315697 0.6926833987554857 4.852377356312498e-07 -0.09192469114756374 -1.0428 0.6926897268305092 0.6926876414431572 4.7643990420953575e-07 -0.09192704525298492 -1.0429000000000002 0.6926939791232488 0.6926918830122719 4.6752938066829675e-07 -0.09192939870099878 -1.043 0.6926982301089473 0.6926961234643181 4.5850816467185584e-07 -0.09193175149177214 -1.0431000000000001 0.6927024797867845 0.6927003628007622 4.493782799902535e-07 -0.09193410362547172 -1.0432000000000001 0.6927067281559615 0.6927046010230491 4.4014177391638043e-07 -0.09193645510226421 -1.0433 0.6927109752157014 0.6927088381326016 4.3080071700229983e-07 -0.09193880592231625 -1.0434 0.692715220965249 0.6927130741308212 4.2135720239311336e-07 -0.09194115608579453 -1.0435 0.6927194654038716 0.6927173090190859 4.118133455424666e-07 -0.09194350559286563 -1.0436 0.6927237085308589 0.6927215427987523 4.021712836504987e-07 -0.09194585444369612 -1.0437 0.6927279503455225 0.6927257754711533 3.924331751989363e-07 -0.09194820263845249 -1.0438 0.6927321908471977 0.6927300070375997 3.826011994514933e-07 -0.0919505501773013 -1.0439 0.6927364300352429 0.6927342374993779 3.72677555988965e-07 -0.09195289706040906 -1.044 0.6927406679090391 0.6927384668577519 3.6266446418881104e-07 -0.0919552432879421 -1.0441 0.6927449044679914 0.6927426951139614 3.5256416277412717e-07 -0.09195758886006689 -1.0442 0.6927491397115282 0.6927469222692226 3.4237890927935055e-07 -0.09195993377694978 -1.0443 0.692753373639102 0.6927511483247277 3.321109795506594e-07 -0.09196227803875712 -1.0444 0.6927576062501897 0.6927553732816447 3.217626672463725e-07 -0.09196462164565522 -1.0445 0.6927618375442914 0.6927595971411169 3.113362833304101e-07 -0.09196696459781037 -1.0446000000000002 0.6927660675209328 0.6927638199042636 3.0083415554493786e-07 -0.09196930689538879 -1.0447 0.6927702961796636 0.6927680415721786 2.902586279315833e-07 -0.09197164853855674 -1.0448 0.6927745235200582 0.6927722621459316 2.79612060220813e-07 -0.09197398952748036 -1.0449000000000002 0.6927787495417159 0.6927764816265664 2.688968273600878e-07 -0.09197632986232578 -1.045 0.6927829742442617 0.6927807000151021 2.581153189865071e-07 -0.09197866954325912 -1.0451000000000001 0.692787197627345 0.6927849173125322 2.472699389063915e-07 -0.09198100857044642 -1.0452000000000001 0.6927914196906413 0.6927891335198251 2.363631045401715e-07 -0.09198334694405384 -1.0453 0.6927956404338509 0.6927933486379232 2.2539724640197045e-07 -0.09198568466424734 -1.0454 0.6927998598567006 0.6927975626677433 2.1437480748204285e-07 -0.09198802173119291 -1.0455 0.6928040779589419 0.6928017756101758 2.0329824283044085e-07 -0.09199035814505652 -1.0456 0.6928082947403532 0.6928059874660857 1.9217001888394147e-07 -0.09199269390600405 -1.0457 0.6928125102007383 0.6928101982363113 1.809926130323658e-07 -0.0919950290142014 -1.0458 0.6928167243399272 0.6928144079216649 1.6976851300101736e-07 -0.0919973634698144 -1.0459 0.6928209371577765 0.6928186165229329 1.5850021627475397e-07 -0.09199969727300893 -1.046 0.6928251486541683 0.6928228240408745 1.471902295949179e-07 -0.09200203042395076 -1.0461 0.6928293588290122 0.6928270304762223 1.358410683903466e-07 -0.09200436292280562 -1.0462 0.6928335676822431 0.6928312358296829 1.2445525621185283e-07 -0.09200669476973922 -1.0463 0.6928377752138236 0.6928354401019361 1.1303532414935757e-07 -0.0920090259649173 -1.0464 0.6928419814237422 0.6928396432936345 1.0158381031147301e-07 -0.09201135650850552 -1.0465 0.6928461863120143 0.692843845405404 9.010325923222706e-08 -0.09201368640066948 -1.0466000000000002 0.6928503898786822 0.6928480464378435 7.859622131248245e-08 -0.09201601564157474 -1.0467 0.692854592123815 0.6928522463915252 6.706525225615156e-08 -0.09201834423138697 -1.0468 0.6928587930475084 0.6928564452669944 5.5512912509880774e-08 -0.09202067217027166 -1.0469000000000002 0.6928629926498853 0.6928606430647685 4.394176666110139e-08 -0.09202299945839422 -1.047 0.6928671909310957 0.6928648397853387 3.2354382929755676e-08 -0.0920253260959202 -1.0471000000000001 0.6928713878913162 0.6928690354291684 2.0753332531653346e-08 -0.09202765208301501 -1.0472000000000001 0.6928755835307506 0.6928732299966944 9.141189160656593e-09 -0.09202997741984403 -1.0473 0.6928797778496301 0.6928774234883259 -2.479471621942564e-09 -0.09203230210657268 -1.0474 0.6928839708482123 0.6928816159044453 -1.4106072926053925e-08 -0.09203462614336626 -1.0475 0.6928881625267822 0.692885807245407 -2.5736037124329814e-08 -0.09203694953039004 -1.0476 0.6928923528856521 0.6928899975115392 -3.736678641898597e-08 -0.09203927226780939 -1.0477 0.6928965419251608 0.6928941867031422 -4.8995743411278745e-08 -0.09204159435578942 -1.0478 0.6929007296456746 0.6928983748204893 -6.062033167152439e-08 -0.0920439157944954 -1.0479 0.6929049160475867 0.6929025618638267 -7.223797631340095e-08 -0.09204623658409253 -1.048 0.6929091011313175 0.6929067478333735 -8.384610456543123e-08 -0.09204855672474589 -1.0481 0.6929132848973139 0.6929109327293212 -9.544214633113585e-08 -0.09205087621662066 -1.0482 0.6929174673460503 0.692915116551835 -1.0702353477141241e-07 -0.09205319505988185 -1.0483 0.6929216484780275 0.6929192993010522 -1.1858770686441755e-07 -0.09205551325469452 -1.0484 0.6929258282937734 0.6929234809770837 -1.3013210397629094e-07 -0.09205783080122365 -1.0485 0.6929300067938433 0.6929276615800132 -1.4165417242147094e-07 -0.09206014769963433 -1.0486000000000002 0.6929341839788182 0.6929318411098975 -1.5315136403862284e-07 -0.09206246395009138 -1.0487 0.6929383598493064 0.6929360195667664 -1.6462113675008716e-07 -0.09206477955275977 -1.0488 0.692942534405943 0.6929401969506237 -1.7606095510658282e-07 -0.09206709450780444 -1.0489000000000002 0.6929467076493889 0.6929443732614453 -1.87468290883952e-07 -0.09206940881539012 -1.049 0.6929508795803321 0.6929485484991814 -1.9884062359490362e-07 -0.0920717224756817 -1.0491000000000001 0.6929550501994869 0.6929527226637553 -2.101754410892276e-07 -0.09207403548884394 -1.0492000000000001 0.6929592195075936 0.6929568957550641 -2.2147024010543692e-07 -0.0920763478550416 -1.0493 0.6929633875054191 0.6929610677729783 -2.3272252677730698e-07 -0.09207865957443934 -1.0494 0.6929675541937559 0.6929652387173422 -2.4392981726184537e-07 -0.0920809706472019 -1.0495 0.6929717195734231 0.6929694085879745 -2.5508963819725894e-07 -0.092083281073494 -1.0496 0.6929758836452649 0.692973577384667 -2.661995273239848e-07 -0.09208559085348016 -1.0497 0.6929800464101517 0.6929777451071866 -2.7725703399122947e-07 -0.09208789998732497 -1.0497999999999998 0.6929842078689796 0.6929819117552736 -2.8825971970514175e-07 -0.09209020847519306 -1.0499 0.69298836802267 0.6929860773286433 -2.9920515865616837e-07 -0.09209251631724891 -1.05 0.6929925268721693 0.6929902418269851 -3.1009093828804346e-07 -0.092094823513657 -1.0501 0.6929966844184496 0.6929944052499631 -3.2091465982514444e-07 -0.09209713006458176 -1.0502 0.6930008406625081 0.6929985675972168 -3.3167393871658124e-07 -0.09209943597018772 -1.0503 0.6930049956053663 0.69300272886836 -3.423664053162079e-07 -0.09210174123063919 -1.0504 0.6930091492480707 0.6930068890629819 -3.5298970524344497e-07 -0.09210404584610053 -1.0505 0.6930133015916925 0.6930110481806468 -3.635414999939024e-07 -0.0921063498167361 -1.0506000000000002 0.6930174526373272 0.6930152062208947 -3.74019467480613e-07 -0.09210865314271019 -1.0507 0.6930216023860944 0.6930193631832415 -3.844213024364884e-07 -0.09211095582418707 -1.0508 0.693025750839138 0.6930235190671787 -3.947447170526974e-07 -0.09211325786133098 -1.0509000000000002 0.6930298979976255 0.6930276738721732 -4.0498744136724385e-07 -0.0921155592543061 -1.051 0.6930340438627478 0.6930318275976692 -4.1514722384783376e-07 -0.09211786000327658 -1.0511000000000001 0.6930381884357197 0.6930359802430868 -4.2522183179433126e-07 -0.09212016010840662 -1.0512000000000001 0.6930423317177791 0.6930401318078223 -4.3520905200489235e-07 -0.09212245956986026 -1.0513 0.6930464737101866 0.6930442822912495 -4.4510669101188727e-07 -0.09212475838780154 -1.0514000000000001 0.6930506144142261 0.6930484316927191 -4.549125757827288e-07 -0.09212705656239462 -1.0515 0.6930547538312041 0.6930525800115588 -4.646245541015115e-07 -0.09212935409380338 -1.0516 0.6930588919624489 0.6930567272470738 -4.742404950269785e-07 -0.09213165098219186 -1.0517 0.6930630288093114 0.6930608733985475 -4.837582893921222e-07 -0.09213394722772401 -1.0517999999999998 0.693067164373164 0.6930650184652408 -4.931758503037842e-07 -0.09213624283056365 -1.0519 0.6930712986554015 0.6930691624463928 -5.024911134826615e-07 -0.09213853779087477 -1.052 0.6930754316574392 0.693073305341221 -5.117020379086235e-07 -0.0921408321088211 -1.0521 0.6930795633807144 0.6930774471489222 -5.208066060358174e-07 -0.09214312578456652 -1.0522 0.6930836938266851 0.6930815878686714 -5.298028243755359e-07 -0.09214541881827483 -1.0523 0.6930878229968296 0.6930857274996229 -5.386887239750004e-07 -0.09214771121010974 -1.0524 0.693091950892647 0.6930898660409106 -5.474623607226725e-07 -0.09215000296023498 -1.0525 0.6930960775156562 0.6930940034916482 -5.56121815861732e-07 -0.0921522940688142 -1.0526000000000002 0.6931002028673963 0.693098139850929 -5.646651964064109e-07 -0.092154584536011 -1.0527 0.6931043269494255 0.6931022751178273 -5.730906354889376e-07 -0.0921568743619891 -1.0528 0.6931084497633221 0.6931064092913972 -5.813962927619931e-07 -0.09215916354691203 -1.0529000000000002 0.6931125713106827 0.693110542370674 -5.895803549677003e-07 -0.09216145209094334 -1.053 0.6931166915931233 0.6931146743546743 -5.976410361319129e-07 -0.09216373999424661 -1.0531000000000001 0.6931208106122775 0.6931188052423958 -6.055765781193267e-07 -0.09216602725698525 -1.0532000000000001 0.6931249283697979 0.6931229350328176 -6.133852508694027e-07 -0.09216831387932278 -1.0533 0.693129044867354 0.6931270637249014 -6.210653528959664e-07 -0.09217059986142251 -1.0534000000000001 0.693133160106634 0.6931311913175913 -6.286152115370092e-07 -0.09217288520344796 -1.0535 0.6931372740893422 0.6931353178098131 -6.36033183426532e-07 -0.09217516990556238 -1.0536 0.6931413868172007 0.6931394432004765 -6.43317654772102e-07 -0.09217745396792913 -1.0537 0.6931454982919478 0.693143567488474 -6.504670419099634e-07 -0.09217973739071156 -1.0537999999999998 0.6931496085153381 0.6931476906726819 -6.574797912772823e-07 -0.09218202017407279 -1.0539 0.6931537174891427 0.6931518127519601 -6.643543800644025e-07 -0.09218430231817626 -1.054 0.6931578252151475 0.6931559337251529 -6.710893164646459e-07 -0.09218658382318501 -1.0541 0.6931619316951539 0.6931600535910891 -6.776831399241123e-07 -0.09218886468926224 -1.0542 0.6931660369309789 0.6931641723485822 -6.841344215163803e-07 -0.09219114491657106 -1.0543 0.6931701409244533 0.6931682899964313 -6.904417643172067e-07 -0.09219342450527457 -1.0544 0.6931742436774228 0.6931724065334207 -6.966038035571831e-07 -0.09219570345553585 -1.0545 0.6931783451917468 0.6931765219583206 -7.026192070797022e-07 -0.09219798176751791 -1.0546000000000002 0.6931824454692987 0.693180636269888 -7.084866754797359e-07 -0.09220025944138381 -1.0547 0.6931865445119645 0.6931847494668656 -7.142049424646579e-07 -0.09220253647729644 -1.0548 0.6931906423216436 0.6931888615479838 -7.197727751317995e-07 -0.09220481287541878 -1.0549000000000002 0.6931947389002482 0.6931929725119597 -7.251889742182493e-07 -0.09220708863591373 -1.055 0.6931988342497017 0.6931970823574984 -7.304523743506541e-07 -0.09220936375894412 -1.0551000000000001 0.6932029283719401 0.6932011910832931 -7.355618443088963e-07 -0.0922116382446728 -1.0552000000000001 0.6932070212689111 0.6932052986880253 -7.405162873452831e-07 -0.09221391209326257 -1.0553 0.6932111129425733 0.6932094051703651 -7.453146412261802e-07 -0.09221618530487634 -1.0554000000000001 0.6932152033948957 0.6932135105289718 -7.499558786899785e-07 -0.09221845787967671 -1.0555 0.693219292627858 0.693217614762494 -7.544390074609719e-07 -0.09222072981782642 -1.0556 0.6932233806434496 0.6932217178695703 -7.587630705963022e-07 -0.09222300111948811 -1.0557 0.69322746744367 0.6932258198488297 -7.629271466941256e-07 -0.09222527178482448 -1.0557999999999998 0.6932315530305277 0.6932299206988914 -7.66930349963002e-07 -0.09222754181399812 -1.0559 0.6932356374060403 0.693234020418366 -7.707718305133282e-07 -0.09222981120717161 -1.056 0.6932397205722335 0.693238119005855 -7.744507746071383e-07 -0.0922320799645075 -1.0561 0.6932438025311414 0.6932422164599519 -7.779664046442258e-07 -0.09223434808616829 -1.0562 0.6932478832848055 0.6932463127792423 -7.813179795229663e-07 -0.09223661557231644 -1.0563 0.6932519628352751 0.6932504079623045 -7.845047946125616e-07 -0.09223888242311445 -1.0564 0.6932560411846063 0.6932545020077091 -7.875261819889623e-07 -0.09224114863872465 -1.0565 0.6932601183348619 0.6932585949140206 -7.903815106846679e-07 -0.09224341421930951 -1.0566000000000002 0.6932641942881108 0.6932626866797971 -7.930701866193379e-07 -0.09224567916503136 -1.0567 0.6932682690464276 0.6932667773035903 -7.955916528357143e-07 -0.09224794347605256 -1.0568 0.6932723426118923 0.6932708667839469 -7.979453896106437e-07 -0.09225020715253536 -1.0569000000000002 0.6932764149865902 0.693274955119408 -8.00130914468955e-07 -0.09225247019464203 -1.057 0.6932804861726105 0.69327904230851 -8.021477824887713e-07 -0.09225473260253472 -1.0571000000000002 0.6932845561720475 0.6932831283497853 -8.039955862182424e-07 -0.09225699437637569 -1.0572000000000001 0.693288624986999 0.693287213241762 -8.056739558004455e-07 -0.09225925551632708 -1.0573 0.6932926926195659 0.6932912969829649 -8.071825590427739e-07 -0.09226151602255103 -1.0574000000000001 0.6932967590718524 0.6932953795719152 -8.085211015002036e-07 -0.09226377589520961 -1.0575 0.6933008243459657 0.6932994610071317 -8.096893265308047e-07 -0.09226603513446491 -1.0576 0.6933048884440146 0.6933035412871305 -8.106870152957413e-07 -0.0922682937404789 -1.0577 0.6933089513681101 0.6933076204104258 -8.115139868702936e-07 -0.09227055171341364 -1.0577999999999999 0.6933130131203644 0.6933116983755307 -8.121700982854918e-07 -0.09227280905343105 -1.0579 0.6933170737028911 0.6933157751809567 -8.126552445142377e-07 -0.09227506576069308 -1.058 0.6933211331178041 0.6933198508252142 -8.129693584574271e-07 -0.09227732183536164 -1.0581 0.6933251913672176 0.6933239253068139 -8.13112410957828e-07 -0.09227957727759856 -1.0582 0.6933292484532458 0.693327998624266 -8.130844108139579e-07 -0.09228183208756569 -1.0583 0.6933333043780023 0.6933320707760815 -8.128854048078393e-07 -0.09228408626542484 -1.0584 0.6933373591435998 0.6933361417607722 -8.125154776772447e-07 -0.09228633981133783 -1.0585 0.6933414127521492 0.6933402115768506 -8.11974752060185e-07 -0.0922885927254663 -1.0586000000000002 0.69334546520576 0.6933442802228313 -8.112633884393983e-07 -0.09229084500797202 -1.0587 0.6933495165065398 0.6933483476972306 -8.103815851145946e-07 -0.09229309665901662 -1.0588 0.6933535666565929 0.6933524139985675 -8.093295782163334e-07 -0.09229534767876173 -1.0589000000000002 0.6933576156580212 0.6933564791253639 -8.081076415533683e-07 -0.09229759806736898 -1.059 0.6933616635129235 0.6933605430761446 -8.067160865710132e-07 -0.09229984782499999 -1.0591000000000002 0.6933657102233943 0.693364605849438 -8.051552622817537e-07 -0.09230209695181625 -1.0592000000000001 0.6933697557915242 0.6933686674437768 -8.034255551819802e-07 -0.0923043454479793 -1.0593 0.6933738002193989 0.6933727278576979 -8.015273892242325e-07 -0.0923065933136506 -1.0594000000000001 0.6933778435090997 0.6933767870897428 -7.994612255812772e-07 -0.09230884054899156 -1.0595 0.6933818856627025 0.6933808451384587 -7.9722756263223e-07 -0.09231108715416367 -1.0596 0.693385926682277 0.6933849020023977 -7.948269357682669e-07 -0.09231333312932825 -1.0597 0.6933899665698877 0.6933889576801184 -7.922599174065015e-07 -0.09231557847464668 -1.0597999999999999 0.6933940053275917 0.6933930121701856 -7.895271166569184e-07 -0.09231782319028027 -1.0599 0.6933980429574396 0.6933970654711704 -7.866291793778846e-07 -0.09232006727639025 -1.06 0.6934020794614747 0.6934011175816519 -7.835667878569597e-07 -0.09232231073313796 -1.0601 0.6934061148417329 0.6934051685002156 -7.803406607692631e-07 -0.09232455356068457 -1.0602 0.6934101491002418 0.6934092182254561 -7.769515529554294e-07 -0.09232679575919127 -1.0603 0.6934141822390205 0.6934132667559751 -7.734002552273189e-07 -0.09232903732881921 -1.0604 0.6934182142600799 0.6934173140903837 -7.696875942708736e-07 -0.09233127826972952 -1.0605 0.6934222451654208 0.6934213602273018 -7.658144323408056e-07 -0.09233351858208329 -1.0606000000000002 0.6934262749570357 0.6934254051653587 -7.617816671773303e-07 -0.0923357582660416 -1.0607 0.6934303036369059 0.6934294489031931 -7.575902317424887e-07 -0.09233799732176544 -1.0608 0.6934343312070035 0.6934334914394547 -7.53241093914836e-07 -0.09234023574941584 -1.0609000000000002 0.693438357669289 0.6934375327728025 -7.487352564200522e-07 -0.0923424735491537 -1.061 0.6934423830257128 0.6934415729019074 -7.44073756567265e-07 -0.09234471072113999 -1.0611000000000002 0.6934464072782133 0.693445611825451 -7.392576659576156e-07 -0.09234694726553559 -1.0612000000000001 0.6934504304287177 0.6934496495421263 -7.342880902483362e-07 -0.09234918318250136 -1.0613 0.6934544524791408 0.693453686050639 -7.291661689584616e-07 -0.09235141847219819 -1.0614000000000001 0.6934584734313851 0.6934577213497064 -7.238930750941286e-07 -0.09235365313478681 -1.0615 0.69346249328734 0.6934617554380585 -7.184700149681644e-07 -0.09235588717042802 -1.0616 0.6934665120488823 0.6934657883144384 -7.128982279919205e-07 -0.0923581205792825 -1.0617 0.6934705297178748 0.6934698199776028 -7.071789861895494e-07 -0.09236035336151104 -1.0617999999999999 0.693474546296167 0.6934738504263218 -7.013135941147386e-07 -0.09236258551727426 -1.0619 0.6934785617855936 0.6934778796593792 -6.953033884343762e-07 -0.09236481704673273 -1.062 0.6934825761879757 0.693481907675574 -6.89149737706507e-07 -0.09236704795004722 -1.0621 0.6934865895051187 0.693485934473719 -6.828540419362428e-07 -0.09236927822737816 -1.0622 0.6934906017388132 0.6934899600526423 -6.764177323953513e-07 -0.09237150787888611 -1.0623 0.6934946128908346 0.6934939844111876 -6.69842271316945e-07 -0.09237373690473162 -1.0624 0.6934986229629421 0.6934980075482142 -6.63129151354247e-07 -0.09237596530507518 -1.0625 0.6935026319568788 0.6935020294625969 -6.562798954556914e-07 -0.09237819308007715 -1.0626000000000002 0.6935066398743717 0.6935060501532271 -6.49296056476345e-07 -0.092380420229898 -1.0627 0.6935106467171308 0.6935100696190131 -6.421792167476958e-07 -0.0923826467546981 -1.0628 0.6935146524868492 0.6935140878588797 -6.349309877862197e-07 -0.09238487265463777 -1.0629000000000002 0.6935186571852023 0.6935181048717691 -6.275530099048021e-07 -0.09238709792987737 -1.063 0.6935226608138484 0.6935221206566409 -6.200469518796714e-07 -0.09238932258057717 -1.0631000000000002 0.6935266633744274 0.6935261352124729 -6.124145105063095e-07 -0.09239154660689743 -1.0632000000000001 0.693530664868561 0.6935301485382601 -6.046574102941404e-07 -0.09239377000899832 -1.0633 0.6935346652978523 0.6935341606330165 -5.96777402994686e-07 -0.09239599278704 -1.0634000000000001 0.6935386646638864 0.6935381714957753 -5.887762672684982e-07 -0.09239821494118272 -1.0635 0.6935426629682281 0.6935421811255877 -5.806558083243374e-07 -0.09240043647158654 -1.0636 0.6935466602124234 0.6935461895215246 -5.724178573363048e-07 -0.09240265737841155 -1.0637 0.6935506563979992 0.6935501966826763 -5.640642712495536e-07 -0.09240487766181786 -1.0637999999999999 0.6935546515264615 0.6935542026081527 -5.555969322390553e-07 -0.09240709732196543 -1.0639 0.6935586455992965 0.6935582072970838 -5.470177472655102e-07 -0.09240931635901423 -1.064 0.6935626386179702 0.6935622107486202 -5.383286477839144e-07 -0.09241153477312422 -1.0641 0.6935666305839279 0.6935662129619327 -5.295315890913033e-07 -0.09241375256445539 -1.0642 0.693570621498594 0.6935702139362129 -5.206285501116459e-07 -0.09241596973316758 -1.0643 0.6935746113633714 0.6935742136706737 -5.11621532819917e-07 -0.09241818627942072 -1.0644 0.6935786001796418 0.693578212164549 -5.025125618673965e-07 -0.09242040220337455 -1.0645 0.6935825879487653 0.693582209417094 -4.933036839988025e-07 -0.09242261750518892 -1.0646000000000002 0.69358657467208 0.6935862054275862 -4.839969677400413e-07 -0.09242483218502355 -1.0647 0.6935905603509018 0.6935902001953247 -4.745945028708509e-07 -0.09242704624303821 -1.0648 0.6935945449865251 0.6935941937196308 -4.65098399939079e-07 -0.09242925967939261 -1.0649000000000002 0.6935985285802209 0.6935981859998481 -4.555107898096544e-07 -0.09243147249424642 -1.065 0.6936025111332375 0.6936021770353432 -4.4583382322049836e-07 -0.09243368468775925 -1.0651000000000002 0.6936064926468006 0.6936061668255047 -4.360696702065958e-07 -0.0924358962600907 -1.0652000000000001 0.6936104731221127 0.6936101553697451 -4.262205197183566e-07 -0.09243810721140035 -1.0653 0.6936144525603529 0.6936141426674993 -4.1628857904568717e-07 -0.09244031754184773 -1.0654000000000001 0.6936184309626766 0.6936181287182263 -4.0627607340165683e-07 -0.09244252725159234 -1.0655 0.693622408330216 0.6936221135214082 -3.96185245395142e-07 -0.0924447363407937 -1.0656 0.693626384664079 0.6936260970765509 -3.8601835444795896e-07 -0.09244694480961119 -1.0657 0.6936303599653495 0.6936300793831842 -3.757776764340415e-07 -0.09244915265820425 -1.0657999999999999 0.6936343342350872 0.6936340604408622 -3.654655030688181e-07 -0.09245135988673227 -1.0659 0.6936383074743275 0.6936380402491631 -3.5508414140961175e-07 -0.09245356649535456 -1.066 0.693642279684081 0.6936420188076893 -3.4463591339767286e-07 -0.09245577248423043 -1.0661 0.6936462508653343 0.6936459961160681 -3.341231552614343e-07 -0.09245797785351918 -1.0662 0.6936502210190482 0.6936499721739515 -3.2354821703078906e-07 -0.09246018260338011 -1.0663 0.693654190146159 0.6936539469810161 -3.129134620652452e-07 -0.09246238673397233 -1.0664 0.693658158247578 0.6936579205369633 -3.022212664155477e-07 -0.09246459024545507 -1.0665 0.6936621253241915 0.69366189284152 -2.9147401832407827e-07 -0.0924667931379875 -1.0666000000000002 0.6936660913768595 0.6936658638944382 -2.806741178189298e-07 -0.09246899541172873 -1.0667 0.6936700564064172 0.6936698336954953 -2.698239759853227e-07 -0.09247119706683782 -1.0668 0.6936740204136744 0.6936738022444939 -2.589260145909045e-07 -0.09247339810347385 -1.0669000000000002 0.6936779833994149 0.6936777695412624 -2.479826653918604e-07 -0.09247559852179586 -1.067 0.6936819453643962 0.6936817355856549 -2.3699636974780502e-07 -0.09247779832196279 -1.0671000000000002 0.6936859063093506 0.6936857003775511 -2.2596957797646477e-07 -0.09247999750413362 -1.0672000000000001 0.6936898662349844 0.6936896639168564 -2.1490474881591393e-07 -0.09248219606846728 -1.0673 0.6936938251419777 0.6936936262035024 -2.0380434891803523e-07 -0.09248439401512265 -1.0674000000000001 0.6936977830309842 0.6936975872374468 -1.9267085226912228e-07 -0.09248659134425861 -1.0675 0.6937017399026315 0.6937015470186729 -1.815067396382375e-07 -0.09248878805603399 -1.0676 0.6937056957575212 0.6937055055471907 -1.7031449802903942e-07 -0.09249098415060754 -1.0677 0.6937096505962284 0.693709462823036 -1.5909662015242687e-07 -0.09249317962813808 -1.0677999999999999 0.6937136044193015 0.6937134188462708 -1.4785560381765095e-07 -0.0924953744887843 -1.0679 0.6937175572272631 0.6937173736169842 -1.3659395142404107e-07 -0.09249756873270495 -1.068 0.6937215090206084 0.6937213271352904 -1.2531416937466844e-07 -0.09249976236005863 -1.0681 0.693725459799807 0.6937252794013311 -1.140187675420512e-07 -0.09250195537100403 -1.0682 0.6937294095653013 0.6937292304152735 -1.0271025868181793e-07 -0.0925041477656997 -1.0683 0.6937333583175074 0.6937331801773121 -9.139115790621904e-08 -0.09250633954430426 -1.0684 0.693737306056815 0.6937371286876672 -8.006398210212706e-08 -0.09250853070697623 -1.0685 0.6937412527835867 0.6937410759465861 -6.873124937679248e-08 -0.09251072125387415 -1.0686000000000002 0.6937451984981586 0.693745021954342 -5.739547850056384e-08 -0.09251291118515642 -1.0687 0.6937491432008407 0.6937489667112349 -4.6059188339849996e-08 -0.09251510050098152 -1.0688 0.6937530868919155 0.6937529102175912 -3.4724897312471154e-08 -0.09251728920150781 -1.0689000000000002 0.69375702957164 0.6937568524737642 -2.3395122812326988e-08 -0.0925194772868938 -1.069 0.6937609712402435 0.6937607934801328 -1.2072380659380877e-08 -0.09252166475729767 -1.0691000000000002 0.6937649118979291 0.693764733237103 -7.591845390189644e-10 -0.0925238516128778 -1.0692000000000002 0.693768851544874 0.693768671745107 1.0541954556693434e-08 -0.0925260378537925 -1.0693 0.6937727901812281 0.6937726090046034 2.1828528887213317e-08 -0.09252822348020001 -1.0694000000000001 0.6937767278071151 0.6937765450160771 3.309803451451154e-08 -0.09253040849225852 -1.0695 0.6937806644226323 0.6937804797800389 4.434797186772532e-08 -0.09253259289012622 -1.0696 0.6937846000278507 0.6937844132970263 5.5575846293065556e-08 -0.09253477667396123 -1.0697 0.6937885346228148 0.6937883455676035 6.67791686011221e-08 -0.09253695984392177 -1.0697999999999999 0.6937924682075431 0.6937922765923594 7.795545562891415e-08 -0.09253914240016581 -1.0699 0.6937964007820279 0.6937962063719101 8.91022307880629e-08 -0.09254132434285148 -1.07 0.693800332346235 0.6938001349068968 1.0021702460949466e-07 -0.09254350567213676 -1.0701 0.6938042629001047 0.6938040621979875 1.1129737529161354e-07 -0.09254568638817963 -1.0702 0.6938081924435509 0.6938079882458754 1.2234082923806566e-07 -0.09254786649113808 -1.0703 0.6938121209764623 0.6938119130512794 1.3334494163019794e-07 -0.09255004598117007 -1.0704 0.6938160484987013 0.6938158366149443 1.4430727692665846e-07 -0.09255222485843345 -1.0705 0.6938199750101044 0.69381975893764 1.5522540944279406e-07 -0.09255440312308603 -1.0706000000000002 0.6938239005104833 0.6938236800201623 1.6609692384331187e-07 -0.0925565807752857 -1.0707 0.6938278249996239 0.6938275998633319 1.7691941573208525e-07 -0.09255875781519025 -1.0708 0.6938317484772869 0.6938315184679946 1.8769049213787636e-07 -0.09256093424295744 -1.0709000000000002 0.6938356709432079 0.6938354358350218 1.9840777205903937e-07 -0.092563110058745 -1.071 0.6938395923970972 0.6938393519653089 2.0906888700475412e-07 -0.09256528526271063 -1.0711000000000002 0.6938435128386407 0.6938432668597766 2.1967148148421822e-07 -0.092567459855012 -1.0712000000000002 0.6938474322674986 0.6938471805193707 2.302132135617585e-07 -0.09256963383580676 -1.0713 0.6938513506833075 0.6938510929450603 2.4069175535990084e-07 -0.09257180720525247 -1.0714000000000001 0.6938552680856789 0.69385500413784 2.5110479358325666e-07 -0.09257397996350675 -1.0715 0.6938591844742004 0.6938589140987275 2.6145002999383715e-07 -0.09257615211072712 -1.0716 0.6938630998484352 0.6938628228287653 2.717251819453481e-07 -0.0925783236470711 -1.0717 0.6938670142079224 0.6938667303290195 2.8192798293136256e-07 -0.09258049457269607 -1.0717999999999999 0.6938709275521777 0.6938706366005793 2.9205618301553216e-07 -0.09258266488775957 -1.0719 0.6938748398806935 0.6938745416445585 3.0210754933118755e-07 -0.09258483459241901 -1.072 0.6938787511929376 0.693878445462093 3.1207986661563325e-07 -0.09258700368683172 -1.0721 0.6938826614883555 0.6938823480543427 3.2197093768893126e-07 -0.09258917217115507 -1.0722 0.6938865707663696 0.69388624942249 3.31778583918807e-07 -0.0925913400455464 -1.0723 0.6938904790263791 0.6938901495677399 3.415006457480052e-07 -0.09259350731016297 -1.0724 0.6938943862677609 0.6938940484913199 3.511349830412347e-07 -0.092595673965162 -1.0725 0.6938982924898693 0.6938979461944801 3.6067947572354653e-07 -0.09259784001070075 -1.0726000000000002 0.6939021976920362 0.6939018426784924 3.7013202414115653e-07 -0.09260000544693636 -1.0727 0.6939061018735719 0.6939057379446506 3.794905496165568e-07 -0.09260217027402602 -1.0728 0.6939100050337648 0.6939096319942701 3.8875299476076597e-07 -0.0926043344921268 -1.0729000000000002 0.6939139071718818 0.6939135248286878 3.979173240492573e-07 -0.09260649810139587 -1.073 0.6939178082871682 0.6939174164492616 4.069815242174757e-07 -0.0926086611019902 -1.0731000000000002 0.6939217083788487 0.6939213068573704 4.1594360473962144e-07 -0.09261082349406685 -1.0732000000000002 0.6939256074461272 0.6939251960544137 4.248015981686559e-07 -0.09261298527778283 -1.0733 0.6939295054881863 0.693929084041812 4.33553560767741e-07 -0.0926151464532951 -1.0734000000000001 0.6939334025041893 0.6939329708210047 4.4219757273228355e-07 -0.09261730702076056 -1.0735 0.6939372984932788 0.6939368563934522 4.507317386687193e-07 -0.09261946698033609 -1.0736 0.6939411934545774 0.6939407407606342 4.591541880871741e-07 -0.09262162633217857 -1.0737 0.6939450873871891 0.6939446239240501 4.6746307573453105e-07 -0.09262378507644488 -1.0737999999999999 0.6939489802901977 0.693948505885218 4.7565658205239725e-07 -0.09262594321329176 -1.0739 0.6939528721626684 0.6939523866456746 4.837329135171098e-07 -0.09262810074287599 -1.074 0.6939567630036482 0.6939562662069758 4.916903030005582e-07 -0.09263025766535432 -1.0741 0.6939606528121648 0.6939601445706958 4.995270103391736e-07 -0.09263241398088348 -1.0742 0.693964541587228 0.6939640217384259 5.072413225004624e-07 -0.09263456968962006 -1.0743 0.6939684293278301 0.6939678977117759 5.148315541103621e-07 -0.0926367247917207 -1.0744 0.6939723160329455 0.6939717724923731 5.22296047730797e-07 -0.09263887928734207 -1.0745 0.6939762017015317 0.6939756460818614 5.296331742482563e-07 -0.09264103317664073 -1.0746000000000002 0.6939800863325292 0.6939795184819015 5.368413332484945e-07 -0.0926431864597732 -1.0747 0.6939839699248613 0.6939833896941712 5.439189533912314e-07 -0.09264533913689597 -1.0748 0.693987852477436 0.6939872597203638 5.508644926738304e-07 -0.09264749120816555 -1.0749000000000002 0.693991733989144 0.6939911285621889 5.576764387643651e-07 -0.09264964267373835 -1.075 0.6939956144588615 0.6939949962213716 5.643533094734643e-07 -0.09265179353377083 -1.0751000000000002 0.6939994938854487 0.693998862699652 5.708936529069675e-07 -0.09265394378841935 -1.0752000000000002 0.6940033722677508 0.6940027279987855 5.772960479100142e-07 -0.09265609343784022 -1.0753 0.6940072496045984 0.6940065921205415 5.835591042613331e-07 -0.09265824248218979 -1.0754000000000001 0.6940111258948076 0.6940104550667044 5.896814630618197e-07 -0.09266039092162437 -1.0755 0.6940150011371804 0.6940143168390721 5.956617970676037e-07 -0.09266253875630018 -1.0756000000000001 0.6940188753305054 0.694018177439456 6.014988108149488e-07 -0.09266468598637345 -1.0757 0.6940227484735574 0.694022036869681 6.071912409810754e-07 -0.09266683261200037 -1.0757999999999999 0.6940266205650982 0.6940258951315847 6.127378568282493e-07 -0.09266897863333709 -1.0759 0.6940304916038773 0.6940297522270176 6.181374602315381e-07 -0.09267112405053972 -1.076 0.6940343615886309 0.6940336081578418 6.233888859841219e-07 -0.09267326886376431 -1.0761 0.6940382305180843 0.6940374629259322 6.284910021026047e-07 -0.09267541307316701 -1.0762 0.6940420983909508 0.6940413165331742 6.334427101462037e-07 -0.09267755667890379 -1.0763 0.6940459652059321 0.6940451689814651 6.382429453138938e-07 -0.0926796996811307 -1.0764 0.6940498309617193 0.6940490202727125 6.428906766942077e-07 -0.09268184208000367 -1.0765 0.6940536956569926 0.6940528704088349 6.473849075844251e-07 -0.09268398387567862 -1.0766000000000002 0.6940575592904221 0.6940567193917604 6.517246756015949e-07 -0.09268612506831142 -1.0767 0.6940614218606682 0.6940605672234271 6.559090529600908e-07 -0.09268826565805798 -1.0768 0.6940652833663817 0.6940644139057823 6.599371465826342e-07 -0.09269040564507407 -1.0769000000000002 0.6940691438062043 0.6940682594407828 6.63808098405605e-07 -0.09269254502951559 -1.077 0.694073003178769 0.6940721038303932 6.675210854484304e-07 -0.09269468381153823 -1.0771000000000002 0.6940768614827001 0.6940759470765869 6.710753201188968e-07 -0.09269682199129775 -1.0772 0.6940807187166146 0.6940797891813448 6.744700501992718e-07 -0.09269895956894991 -1.0773 0.6940845748791212 0.6940836301466559 6.777045591793707e-07 -0.09270109654465032 -1.0774000000000001 0.6940884299688217 0.6940874699745152 6.807781663814572e-07 -0.09270323291855465 -1.0775 0.694092283984311 0.6940913086669256 6.836902270435097e-07 -0.09270536869081848 -1.0776000000000001 0.6940961369241772 0.6940951462258957 6.864401324302438e-07 -0.09270750386159743 -1.0777 0.6940999887870025 0.6940989826534403 6.890273100274014e-07 -0.09270963843104697 -1.0777999999999999 0.6941038395713637 0.6941028179515798 6.914512236805281e-07 -0.09271177239932273 -1.0779 0.6941076892758319 0.6941066521223394 6.937113735672185e-07 -0.09271390576658009 -1.078 0.6941115378989732 0.6941104851677493 6.958072964746709e-07 -0.0927160385329745 -1.0781 0.6941153854393494 0.6941143170898447 6.97738565813566e-07 -0.09271817069866145 -1.0782 0.6941192318955177 0.6941181478906642 6.995047916735775e-07 -0.09272030226379624 -1.0783 0.6941230772660322 0.6941219775722501 7.011056210176614e-07 -0.0927224332285343 -1.0784 0.694126921549443 0.6941258061366482 7.025407375571557e-07 -0.09272456359303091 -1.0785 0.6941307647442974 0.6941296335859072 7.038098620293365e-07 -0.09272669335744134 -1.0786000000000002 0.6941346068491396 0.6941334599220779 7.049127520863951e-07 -0.09272882252192087 -1.0787 0.6941384478625126 0.6941372851472134 7.058492024342167e-07 -0.09273095108662469 -1.0788 0.6941422877829567 0.6941411092633689 7.066190448462573e-07 -0.09273307905170802 -1.0789000000000002 0.6941461266090113 0.6941449322726005 7.072221482051777e-07 -0.09273520641732608 -1.079 0.6941499643392144 0.6941487541769653 7.076584185167212e-07 -0.09273733318363392 -1.0791000000000002 0.6941538009721031 0.6941525749785207 7.079277988264465e-07 -0.09273945935078667 -1.0792 0.6941576365062146 0.6941563946793246 7.080302693723839e-07 -0.09274158491893937 -1.0793 0.6941614709400861 0.6941602132814344 7.079658475572792e-07 -0.09274370988824705 -1.0794000000000001 0.6941653042722555 0.694164030786907 7.07734587823694e-07 -0.09274583425886472 -1.0795 0.6941691365012613 0.6941678471977984 7.073365817789057e-07 -0.09274795803094736 -1.0796000000000001 0.6941729676256438 0.6941716625161628 7.067719580422516e-07 -0.09275008120464992 -1.0797 0.6941767976439439 0.6941754767440529 7.060408822867625e-07 -0.09275220378012726 -1.0797999999999999 0.6941806265547058 0.6941792898835187 7.051435571836517e-07 -0.09275432575753423 -1.0799 0.6941844543564752 0.6941831019366083 7.040802223051701e-07 -0.09275644713702569 -1.08 0.6941882810478016 0.6941869129053663 7.028511541246063e-07 -0.09275856791875646 -1.0801 0.694192106627237 0.694190722791834 7.014566659330201e-07 -0.09276068810288132 -1.0802 0.6941959310933372 0.6941945315980497 6.99897107672709e-07 -0.09276280768955505 -1.0803 0.6941997544446622 0.6941983393260462 6.981728660204745e-07 -0.0927649266789323 -1.0804 0.6942035766797758 0.6942021459778529 6.962843641239447e-07 -0.09276704507116779 -1.0805 0.6942073977972476 0.6942059515554935 6.94232061601574e-07 -0.09276916286641612 -1.0806000000000002 0.6942112177956514 0.6942097560609867 6.92016454362232e-07 -0.0927712800648319 -1.0807 0.6942150366735671 0.6942135594963457 6.896380745913255e-07 -0.09277339666656975 -1.0808 0.6942188544295805 0.6942173618635774 6.870974905148763e-07 -0.09277551267178426 -1.0809000000000002 0.6942226710622834 0.6942211631646826 6.843953063162544e-07 -0.0927776280806299 -1.081 0.6942264865702743 0.6942249634016548 6.815321620251558e-07 -0.09277974289326113 -1.0811000000000002 0.694230300952159 0.6942287625764807 6.785087332955575e-07 -0.09278185710983243 -1.0812 0.6942341142065509 0.694232560691139 6.753257313085737e-07 -0.09278397073049825 -1.0813 0.6942379263320708 0.694236357747601 6.71983902578166e-07 -0.09278608375541299 -1.0814000000000001 0.6942417373273476 0.6942401537478289 6.68484028756855e-07 -0.0927881961847309 -1.0815 0.6942455471910192 0.694243948693777 6.648269264830642e-07 -0.0927903080186064 -1.0816000000000001 0.6942493559217322 0.6942477425873901 6.610134471868312e-07 -0.09279241925719373 -1.0817 0.6942531635181421 0.6942515354306038 6.570444769232742e-07 -0.09279452990064717 -1.0817999999999999 0.6942569699789148 0.6942553272253442 6.529209360672805e-07 -0.09279663994912096 -1.0819 0.6942607753027259 0.6942591179735262 6.486437792163624e-07 -0.09279874940276932 -1.082 0.6942645794882611 0.6942629076770557 6.442139949686121e-07 -0.0928008582617464 -1.0821 0.6942683825342171 0.6942666963378261 6.396326055480017e-07 -0.09280296652620632 -1.0822 0.6942721844393014 0.6942704839577214 6.349006667488721e-07 -0.09280507419630324 -1.0823 0.694275985202233 0.6942742705386125 6.30019267602866e-07 -0.09280718127219113 -1.0824 0.694279784821743 0.6942780560823588 6.249895301846387e-07 -0.09280928775402408 -1.0825 0.6942835832965741 0.6942818405908078 6.198126092510359e-07 -0.09281139364195608 -1.0826000000000002 0.6942873806254819 0.6942856240657946 6.144896920051712e-07 -0.09281349893614112 -1.0827 0.6942911768072346 0.6942894065091407 6.090219979715261e-07 -0.09281560363673316 -1.0828 0.6942949718406136 0.6942931879226546 6.034107785102272e-07 -0.09281770774388609 -1.0829000000000002 0.6942987657244135 0.6942969683081314 5.976573166505128e-07 -0.09281981125775379 -1.083 0.6943025584574432 0.694300747667352 5.917629268548108e-07 -0.09282191417849012 -1.0831000000000002 0.6943063500385251 0.6943045260020828 5.857289545468936e-07 -0.09282401650624883 -1.0832 0.6943101404664964 0.6943083033140761 5.795567759592224e-07 -0.09282611824118372 -1.0833 0.6943139297402094 0.6943120796050694 5.732477977027362e-07 -0.09282821938344861 -1.0834000000000001 0.6943177178585312 0.6943158548767843 5.668034565031732e-07 -0.09283031993319717 -1.0835 0.6943215048203439 0.6943196291309277 5.602252189235157e-07 -0.09283241989058309 -1.0836000000000001 0.6943252906245461 0.6943234023691899 5.535145809337783e-07 -0.09283451925576004 -1.0837 0.6943290752700515 0.6943271745932451 5.466730676889631e-07 -0.0928366180288816 -1.0837999999999999 0.6943328587557908 0.6943309458047516 5.397022330988488e-07 -0.09283871621010138 -1.0839 0.694336641080711 0.6943347160053506 5.326036594394123e-07 -0.09284081379957293 -1.084 0.6943404222437766 0.6943384851966663 5.253789570613954e-07 -0.09284291079744982 -1.0841 0.6943442022439685 0.6943422533803052 5.180297640433595e-07 -0.09284500720388549 -1.0842 0.6943479810802857 0.6943460205578567 5.105577457475974e-07 -0.09284710301903343 -1.0843 0.6943517587517447 0.6943497867308919 5.029645945842098e-07 -0.09284919824304705 -1.0844 0.69435553525738 0.6943535519009638 4.952520294004836e-07 -0.09285129287607975 -1.0845 0.6943593105962448 0.6943573160696073 4.874217952727244e-07 -0.09285338691828493 -1.0846000000000002 0.6943630847674106 0.6943610792383377 4.794756630899233e-07 -0.0928554803698159 -1.0847 0.6943668577699679 0.6943648414086521 4.714154290680339e-07 -0.09285757323082598 -1.0848 0.6943706296030261 0.6943686025820277 4.632429144307837e-07 -0.09285966550146836 -1.0849000000000002 0.6943744002657145 0.6943723627599228 4.549599650210956e-07 -0.09286175718189639 -1.085 0.6943781697571819 0.6943761219437753 4.465684507737322e-07 -0.09286384827226324 -1.0851000000000002 0.6943819380765968 0.6943798801350032 4.380702652989621e-07 -0.09286593877272205 -1.0852 0.6943857052231476 0.6943836373350045 4.294673255911263e-07 -0.09286802868342597 -1.0853 0.6943894711960439 0.6943873935451562 4.207615715637325e-07 -0.0928701180045281 -1.0854000000000001 0.6943932359945151 0.6943911487668151 4.1195496542495436e-07 -0.09287220673618156 -1.0855 0.6943969996178123 0.6943949030013166 4.030494914833427e-07 -0.09287429487853935 -1.0856000000000001 0.694400762065207 0.6943986562499747 3.940471555441416e-07 -0.09287638243175451 -1.0857 0.6944045233359923 0.6944024085140825 3.8494998456928275e-07 -0.09287846939598005 -1.0857999999999999 0.6944082834294829 0.6944061597949109 3.7576002604594594e-07 -0.09288055577136885 -1.0859 0.6944120423450151 0.6944099100937092 3.664793477575756e-07 -0.09288264155807385 -1.086 0.6944158000819471 0.6944136594117045 3.571100371316249e-07 -0.09288472675624798 -1.0861 0.6944195566396596 0.6944174077501019 3.4765420085791643e-07 -0.09288681136604407 -1.0862 0.6944233120175554 0.6944211551100834 3.381139644098585e-07 -0.09288889538761495 -1.0863 0.6944270662150597 0.6944249014928088 3.2849147151708946e-07 -0.09289097882111336 -1.0864 0.6944308192316206 0.6944286468994147 3.187888837768993e-07 -0.09289306166669212 -1.0865 0.6944345710667098 0.6944323913310154 3.0900838007830167e-07 -0.09289514392450399 -1.0866000000000002 0.6944383217198207 0.6944361347887006 2.99152156199578e-07 -0.09289722559470154 -1.0867 0.6944420711904706 0.6944398772735378 2.892224241629604e-07 -0.09289930667743751 -1.0868 0.694445819478201 0.6944436187865705 2.792214119709535e-07 -0.09290138717286453 -1.0869000000000002 0.6944495665825761 0.6944473593288183 2.691513628430564e-07 -0.0929034670811352 -1.087 0.694453312503184 0.6944510989012773 2.5901453497984006e-07 -0.09290554640240208 -1.0871000000000002 0.6944570572396369 0.6944548375049189 2.4881320083436353e-07 -0.09290762513681768 -1.0872 0.6944608007915711 0.6944585751406911 2.3854964670277923e-07 -0.09290970328453454 -1.0873 0.6944645431586469 0.6944623118095168 2.2822617222473252e-07 -0.09291178084570512 -1.0874000000000001 0.6944682843405491 0.694466047512295 2.1784508985600581e-07 -0.09291385782048184 -1.0875 0.6944720243369867 0.6944697822498997 2.0740872432034596e-07 -0.09291593420901709 -1.0876000000000001 0.6944757631476937 0.694473516023181 1.9691941209598607e-07 -0.0929180100114633 -1.0877000000000001 0.6944795007724281 0.6944772488329629 1.8637950096461742e-07 -0.09292008522797277 -1.0877999999999999 0.694483237210974 0.6944809806800454 1.7579134935566398e-07 -0.09292215985869788 -1.0879 0.6944869724631391 0.6944847115652029 1.6515732593341825e-07 -0.09292423390379081 -1.088 0.6944907065287564 0.6944884414891852 1.5447980901764358e-07 -0.0929263073634039 -1.0881 0.6944944394076846 0.6944921704527163 1.437611860527488e-07 -0.09292838023768929 -1.0882 0.6944981710998075 0.6944958984564948 1.330038531047184e-07 -0.09293045252679923 -1.0883 0.6945019016050336 0.6944996255011946 1.2221021426783718e-07 -0.0929325242308858 -1.0884 0.6945056309232971 0.6945033515874632 1.1138268119978423e-07 -0.09293459535010117 -1.0885 0.6945093590545579 0.6945070767159229 1.0052367250060201e-07 -0.09293666588459737 -1.0886000000000002 0.6945130859988015 0.6945108008871708 8.963561326513769e-08 -0.09293873583452658 -1.0887 0.6945168117560383 0.6945145241017772 7.872093445160377e-08 -0.09294080520004071 -1.0888 0.694520536326305 0.6945182463602878 6.77820724218764e-08 -0.09294287398129181 -1.0889000000000002 0.6945242597096635 0.6945219676632215 5.682146831526014e-08 -0.09294494217843181 -1.089 0.6945279819062019 0.694525688011072 4.584156757664326e-08 -0.09294700979161263 -1.0891000000000002 0.6945317029160338 0.6945294074043065 3.484481936842643e-08 -0.09294907682098619 -1.0892 0.6945354227392988 0.6945331258433667 2.3833676032758433e-08 -0.09295114326670434 -1.0893 0.6945391413761621 0.6945368433286683 1.2810592558108735e-08 -0.09295320912891894 -1.0894000000000001 0.6945428588268148 0.6945405598606009 1.7780260076760701e-09 -0.09295527440778176 -1.0895 0.694546575091474 0.694544275439528 -9.261564996691785e-09 -0.09295733910344454 -1.0896000000000001 0.6945502901703828 0.6945479900657874 -2.0305720852594605e-08 -0.09295940321605908 -1.0897000000000001 0.6945540040638098 0.6945517037396902 -3.1351981510940874e-08 -0.09296146674577709 -1.0897999999999999 0.69455771677205 0.6945554164615222 -4.239788701794044e-08 -0.09296352969275017 -1.0899 0.694561428295424 0.6945591282315428 -5.34409780747697e-08 -0.09296559205713004 -1.09 0.694565138634278 0.6945628390499854 -6.447879658021474e-08 -0.09296765383906824 -1.0901 0.6945688477889846 0.6945665489170578 -7.550888617537457e-08 -0.09296971503871644 -1.0902 0.6945725557599416 0.6945702578329411 -8.652879279497788e-08 -0.0929717756562261 -1.0903 0.6945762625475735 0.6945739657977914 -9.753606521317043e-08 -0.0929738356917488 -1.0904 0.6945799681523296 0.694577672811738 -1.0852825558377299e-07 -0.09297589514543596 -1.0905 0.6945836725746856 0.6945813788748845 -1.1950291998845397e-07 -0.09297795401743905 -1.0906000000000002 0.6945873758151423 0.6945850839873092 -1.304576189783968e-07 -0.09298001230790948 -1.0907 0.6945910778742268 0.6945887881490647 -1.4138991811032953e-07 -0.09298207001699868 -1.0908 0.6945947787524911 0.6945924913601768 -1.5229738851291197e-07 -0.09298412714485793 -1.0909 0.6945984784505134 0.6945961936206468 -1.6317760740194864e-07 -0.09298618369163864 -1.091 0.6946021769688966 0.6945998949304502 -1.7402815861988774e-07 -0.09298823965749203 -1.0911000000000002 0.6946058743082693 0.6946035952895366 -1.8484663317011596e-07 -0.09299029504256942 -1.0912 0.6946095704692856 0.6946072946978306 -1.9563062977900891e-07 -0.09299234984702201 -1.0913 0.6946132654526245 0.6946109931552313 -2.063777553885926e-07 -0.09299440407100096 -1.0914000000000001 0.6946169592589901 0.6946146906616125 -2.170856257324716e-07 -0.09299645771465748 -1.0915 0.6946206518891114 0.694618387216823 -2.2775186581808216e-07 -0.0929985107781427 -1.0916000000000001 0.6946243433437427 0.6946220828206864 -2.383741104818038e-07 -0.09300056326160766 -1.0917000000000001 0.6946280336236624 0.6946257774730016 -2.4895000492325403e-07 -0.09300261516520347 -1.0917999999999999 0.6946317227296744 0.6946294711735426 -2.594772051979499e-07 -0.09300466648908118 -1.0919 0.6946354106626067 0.6946331639220589 -2.699533787550723e-07 -0.09300671723339181 -1.092 0.6946390974233119 0.6946368557182752 -2.8037620495788285e-07 -0.09300876739828633 -1.0921 0.6946427830126665 0.6946405465618914 -2.9074337556250773e-07 -0.09301081698391561 -1.0922 0.6946464674315713 0.6946442364525842 -3.010525952973353e-07 -0.09301286599043064 -1.0923 0.6946501506809513 0.6946479253900051 -3.113015823244525e-07 -0.09301491441798225 -1.0924 0.6946538327617555 0.6946516133737823 -3.2148806870802016e-07 -0.09301696226672136 -1.0925 0.6946575136749562 0.6946553004035192 -3.3160980103530413e-07 -0.09301900953679866 -1.0926000000000002 0.6946611934215496 0.6946589864787966 -3.4166454077055874e-07 -0.09302105622836503 -1.0927 0.6946648720025551 0.6946626715991713 -3.516500648864662e-07 -0.09302310234157114 -1.0928 0.6946685494190155 0.6946663557641767 -3.615641662457758e-07 -0.09302514787656779 -1.0929 0.6946722256719959 0.6946700389733229 -3.7140465410784307e-07 -0.09302719283350563 -1.093 0.6946759007625856 0.6946737212260973 -3.8116935471149693e-07 -0.09302923721253525 -1.0931000000000002 0.6946795746918957 0.6946774025219644 -3.9085611164974e-07 -0.09303128101380741 -1.0932 0.69468324746106 0.6946810828603658 -4.0046278638322663e-07 -0.09303332423747258 -1.0933 0.6946869190712346 0.6946847622407208 -4.099872586565967e-07 -0.0930353668836814 -1.0934000000000001 0.6946905895235977 0.6946884406624269 -4.194274270882814e-07 -0.09303740895258433 -1.0935 0.6946942588193494 0.6946921181248588 -4.287812095382648e-07 -0.09303945044433191 -1.0936000000000001 0.6946979269597113 0.6946957946273699 -4.3804654361462303e-07 -0.09304149135907461 -1.0937000000000001 0.6947015939459271 0.6946994701692915 -4.4722138706210224e-07 -0.0930435316969628 -1.0937999999999999 0.6947052597792611 0.694703144749934 -4.5630371833110805e-07 -0.09304557145814692 -1.0939 0.6947089244609992 0.6947068183685865 -4.6529153687607794e-07 -0.09304761064277739 -1.094 0.6947125879924476 0.6947104910245168 -4.741828636967149e-07 -0.09304964925100447 -1.0941 0.6947162503749335 0.6947141627169726 -4.829757417890157e-07 -0.09305168728297852 -1.0942 0.694719911609804 0.6947178334451803 -4.916682364991543e-07 -0.09305372473884975 -1.0943 0.6947235716984266 0.6947215032083467 -5.002584360022655e-07 -0.09305576161876843 -1.0944 0.6947272306421888 0.6947251720056586 -5.087444516771455e-07 -0.09305779792288478 -1.0945 0.6947308884424976 0.6947288398362828 -5.171244185780965e-07 -0.09305983365134898 -1.0946000000000002 0.6947345451007793 0.6947325066993663 -5.253964958373825e-07 -0.09306186880431118 -1.0947 0.6947382006184792 0.6947361725940375 -5.335588670121738e-07 -0.09306390338192147 -1.0948 0.6947418549970616 0.6947398375194054 -5.416097405702702e-07 -0.09306593738432994 -1.0949 0.6947455082380096 0.6947435014745607 -5.495473501399006e-07 -0.0930679708116867 -1.095 0.6947491603428243 0.6947471644585752 -5.573699551064681e-07 -0.09307000366414171 -1.0951000000000002 0.6947528113130244 0.6947508264705026 -5.650758409109224e-07 -0.0930720359418449 -1.0952 0.6947564611501469 0.694754487509379 -5.726633192648656e-07 -0.09307406764494632 -1.0953 0.6947601098557467 0.6947581475742228 -5.801307287472968e-07 -0.09307609877359585 -1.0954000000000002 0.6947637574313947 0.6947618066640349 -5.874764350405348e-07 -0.0930781293279434 -1.0955 0.69476740387868 0.6947654647777993 -5.946988313187962e-07 -0.09308015930813882 -1.0956000000000001 0.6947710491992074 0.6947691219144834 -6.017963386784064e-07 -0.09308218871433195 -1.0957000000000001 0.6947746933945979 0.6947727780730377 -6.08767406276578e-07 -0.09308421754667252 -1.0957999999999999 0.6947783364664892 0.6947764332523971 -6.15610511942033e-07 -0.09308624580531039 -1.0959 0.6947819784165343 0.6947800874514806 -6.223241622582698e-07 -0.09308827349039524 -1.096 0.6947856192464017 0.6947837406691912 -6.289068930631636e-07 -0.09309030060207678 -1.0961 0.694789258957775 0.6947873929044175 -6.353572697542775e-07 -0.0930923271405047 -1.0962 0.6947928975523522 0.6947910441560323 -6.416738874415184e-07 -0.09309435310582863 -1.0963 0.6947965350318458 0.6947946944228944 -6.478553714883706e-07 -0.09309637849819812 -1.0964 0.6948001713979831 0.6947983437038485 -6.539003775396512e-07 -0.09309840331776284 -1.0965 0.6948038066525045 0.6948019919977247 -6.598075921182556e-07 -0.09310042756467224 -1.0966000000000002 0.694807440797164 0.6948056393033402 -6.655757326529121e-07 -0.09310245123907591 -1.0967 0.694811073833729 0.6948092856194983 -6.712035479500278e-07 -0.09310447434112329 -1.0968 0.6948147057639792 0.6948129309449899 -6.766898182769543e-07 -0.09310649687096381 -1.0969 0.6948183365897074 0.6948165752785931 -6.82033355778322e-07 -0.09310851882874693 -1.097 0.6948219663127184 0.6948202186190733 -6.872330046980846e-07 -0.09311054021462206 -1.0971000000000002 0.6948255949348282 0.6948238609651847 -6.922876415738077e-07 -0.09311256102873845 -1.0972 0.6948292224578649 0.6948275023156696 -6.971961755697365e-07 -0.0931145812712455 -1.0973 0.694832848883667 0.6948311426692588 -7.019575486294505e-07 -0.09311660094229245 -1.0974000000000002 0.6948364742140847 0.6948347820246726 -7.065707357672979e-07 -0.09311862004202853 -1.0975 0.6948400984509777 0.6948384203806208 -7.11034745276562e-07 -0.09312063857060307 -1.0976000000000001 0.6948437215962167 0.6948420577358028 -7.153486188404834e-07 -0.0931226565281652 -1.0977000000000001 0.6948473436516811 0.6948456940889081 -7.195114318514495e-07 -0.0931246739148641 -1.0977999999999999 0.6948509646192603 0.6948493294386171 -7.235222936469166e-07 -0.09312669073084892 -1.0979 0.6948545845008521 0.6948529637836007 -7.273803475787988e-07 -0.09312870697626868 -1.098 0.6948582032983635 0.6948565971225213 -7.310847712355129e-07 -0.09313072265127252 -1.0981 0.6948618210137092 0.6948602294540327 -7.34634776705656e-07 -0.09313273775600944 -1.0982 0.6948654376488124 0.6948638607767808 -7.380296106751505e-07 -0.09313475229062845 -1.0983 0.6948690532056032 0.6948674910894039 -7.412685545105102e-07 -0.0931367662552785 -1.0984 0.6948726676860193 0.6948711203905332 -7.443509245502744e-07 -0.09313877965010857 -1.0985 0.694876281092005 0.6948747486787928 -7.472760721882743e-07 -0.09314079247526758 -1.0986000000000002 0.694879893425511 0.6948783759528 -7.500433840401666e-07 -0.09314280473090436 -1.0987 0.694883504688494 0.6948820022111661 -7.526522818601666e-07 -0.09314481641716776 -1.0988 0.6948871148829165 0.694885627452497 -7.551022230961602e-07 -0.09314682753420664 -1.0989 0.694890724010746 0.6948892516753928 -7.57392700626025e-07 -0.09314883808216977 -1.099 0.6948943320739553 0.6948928748784483 -7.595232429796761e-07 -0.09315084806120583 -1.0991000000000002 0.6948979390745214 0.6948964970602545 -7.614934145055985e-07 -0.09315285747146361 -1.0992 0.6949015450144254 0.694900118219397 -7.633028153569699e-07 -0.09315486631309179 -1.0993 0.6949051498956524 0.6949037383544585 -7.649510815610494e-07 -0.093156874586239 -1.0994000000000002 0.694908753720191 0.6949073574640177 -7.664378852412224e-07 -0.09315888229105387 -1.0995 0.6949123564900324 0.6949109755466498 -7.677629345614889e-07 -0.093160889427685 -1.0996000000000001 0.6949159582071709 0.6949145926009281 -7.689259738652421e-07 -0.09316289599628094 -1.0997000000000001 0.6949195588736026 0.6949182086254229 -7.699267834809786e-07 -0.09316490199699022 -1.0997999999999999 0.6949231584913258 0.6949218236187027 -7.70765180124755e-07 -0.09316690742996135 -1.0999 0.6949267570623401 0.6949254375793343 -7.714410167336538e-07 -0.09316891229534281 -1.1 0.694930354588646 0.6949290505058835 -7.719541824380283e-07 -0.093170916593283 -1.1001 0.6949339510722452 0.6949326623969149 -7.7230460270028e-07 -0.09317292032393032 -1.1002 0.6949375465151394 0.6949362732509928 -7.72492239328737e-07 -0.09317492348743317 -1.1003 0.6949411409193303 0.6949398830666812 -7.725170903388756e-07 -0.0931769260839398 -1.1004 0.6949447342868195 0.6949434918425449 -7.723791900643429e-07 -0.09317892811359864 -1.1005 0.6949483266196073 0.6949470995771492 -7.720786091153231e-07 -0.09318092957655792 -1.1006000000000002 0.6949519179196927 0.6949507062690601 -7.716154543369047e-07 -0.09318293047296587 -1.1007 0.6949555081890737 0.6949543119168458 -7.709898688784689e-07 -0.09318493080297074 -1.1008 0.6949590974297459 0.694957916519075 -7.70202031985523e-07 -0.09318693056672062 -1.1009 0.6949626856437028 0.6949615200743202 -7.692521590274559e-07 -0.09318892976436376 -1.101 0.6949662728329348 0.6949651225811555 -7.681405014559051e-07 -0.09319092839604819 -1.1011000000000002 0.6949698589994298 0.6949687240381583 -7.66867346735367e-07 -0.09319292646192208 -1.1012 0.6949734441451714 0.6949723244439092 -7.654330182738089e-07 -0.0931949239621334 -1.1013 0.6949770282721404 0.6949759237969926 -7.638378752977681e-07 -0.09319692089683027 -1.1014000000000002 0.6949806113823123 0.694979522095997 -7.620823128523524e-07 -0.09319891726616059 -1.1015 0.6949841934776584 0.6949831193395156 -7.601667616485841e-07 -0.09320091307027237 -1.1016000000000001 0.6949877745601453 0.6949867155261461 -7.580916879801336e-07 -0.09320290830931352 -1.1017000000000001 0.6949913546317337 0.6949903106544917 -7.558575935706635e-07 -0.09320490298343193 -1.1018 0.6949949336943788 0.694993904723161 -7.534650153934175e-07 -0.09320689709277548 -1.1019 0.6949985117500301 0.6949974977307687 -7.509145257544869e-07 -0.09320889063749199 -1.102 0.6950020888006296 0.695001089675936 -7.482067320152552e-07 -0.09321088361772924 -1.1021 0.6950056648481138 0.6950046805572907 -7.453422764119866e-07 -0.0932128760336351 -1.1022 0.6950092398944107 0.6950082703734675 -7.42321835986437e-07 -0.09321486788535717 -1.1023 0.6950128139414413 0.6950118591231085 -7.391461223915652e-07 -0.09321685917304323 -1.1024 0.6950163869911189 0.6950154468048644 -7.358158817805105e-07 -0.093218849896841 -1.1025 0.6950199590453479 0.695019033417393 -7.323318945429147e-07 -0.09322084005689801 -1.1026000000000002 0.6950235301060244 0.6950226189593613 -7.286949751522664e-07 -0.09322282965336197 -1.1027 0.6950271001750352 0.6950262034294451 -7.249059720410012e-07 -0.09322481868638037 -1.1028 0.6950306692542582 0.6950297868263293 -7.209657672535563e-07 -0.09322680715610084 -1.1029 0.6950342373455611 0.6950333691487087 -7.168752764880049e-07 -0.0932287950626709 -1.103 0.6950378044508015 0.6950369503952878 -7.126354486242104e-07 -0.09323078240623794 -1.1031000000000002 0.695041370571827 0.6950405305647811 -7.082472656405603e-07 -0.09323276918694946 -1.1032 0.6950449357104738 0.6950441096559146 -7.037117424057993e-07 -0.09323475540495291 -1.1033 0.6950484998685675 0.6950476876674245 -6.990299263737176e-07 -0.09323674106039564 -1.1034000000000002 0.6950520630479222 0.6950512645980592 -6.942028973333514e-07 -0.09323872615342511 -1.1035 0.6950556252503398 0.6950548404465777 -6.892317672563264e-07 -0.09324071068418859 -1.1036000000000001 0.6950591864776103 0.6950584152117517 -6.841176800193027e-07 -0.09324269465283333 -1.1037000000000001 0.6950627467315109 0.695061988892365 -6.788618110570299e-07 -0.09324467805950658 -1.1038 0.6950663060138066 0.6950655614872145 -6.734653670570356e-07 -0.09324666090435563 -1.1039 0.6950698643262485 0.6950691329951095 -6.679295859318701e-07 -0.09324864318752765 -1.104 0.695073421670575 0.6950727034148731 -6.622557363056281e-07 -0.09325062490916983 -1.1041 0.6950769780485102 0.6950762727453419 -6.564451173196595e-07 -0.09325260606942928 -1.1042 0.6950805334617642 0.6950798409853665 -6.504990582439918e-07 -0.09325458666845315 -1.1043 0.6950840879120329 0.6950834081338118 -6.444189182969184e-07 -0.0932565667063885 -1.1044 0.6950876414009971 0.6950869741895569 -6.382060862286654e-07 -0.09325854618338236 -1.1045 0.6950911939303228 0.6950905391514968 -6.318619801409797e-07 -0.09326052509958177 -1.1046 0.6950947455016606 0.6950941030185407 -6.253880470014073e-07 -0.0932625034551337 -1.1047 0.6950982961166452 0.695097665789614 -6.187857623934923e-07 -0.09326448125018508 -1.1048 0.6951018457768958 0.6951012274636573 -6.120566301975883e-07 -0.09326645848488285 -1.1049 0.6951053944840144 0.6951047880396278 -6.052021822300357e-07 -0.09326843515937379 -1.105 0.695108942239588 0.695108347516499 -5.982239778962173e-07 -0.09327041127380488 -1.1051000000000002 0.6951124890451856 0.6951119058932613 -5.911236038713685e-07 -0.09327238682832291 -1.1052 0.6951160349023597 0.6951154631689217 -5.839026736842445e-07 -0.09327436182307475 -1.1053 0.6951195798126448 0.6951190193425046 -5.765628273007861e-07 -0.09327633625820703 -1.1054000000000002 0.6951231237775584 0.695122574413052 -5.691057308881975e-07 -0.09327831013386656 -1.1055 0.6951266667985989 0.6951261283796234 -5.615330763431015e-07 -0.09328028345019994 -1.1056000000000001 0.6951302088772481 0.6951296812412967 -5.538465809862281e-07 -0.09328225620735392 -1.1057000000000001 0.6951337500149684 0.6951332329971683 -5.460479870766921e-07 -0.09328422840547512 -1.1058 0.6951372902132036 0.6951367836463529 -5.381390614650483e-07 -0.0932862000447102 -1.1059 0.6951408294733782 0.695140333187984 -5.301215952532856e-07 -0.09328817112520559 -1.106 0.695144367796898 0.6951438816212139 -5.219974032952268e-07 -0.09329014164710785 -1.1061 0.6951479051851492 0.6951474289452153 -5.137683238010116e-07 -0.09329211161056358 -1.1062 0.6951514416394979 0.69515097515918 -5.054362179554572e-07 -0.09329408101571925 -1.1063 0.6951549771612908 0.6951545202623188 -4.970029694878475e-07 -0.09329604986272125 -1.1064 0.6951585117518541 0.695158064253864 -4.884704842555987e-07 -0.09329801815171603 -1.1065 0.6951620454124932 0.6951616071330669 -4.798406897793539e-07 -0.09329998588284993 -1.1066 0.6951655781444934 0.6951651488992001 -4.7111553483358826e-07 -0.09330195305626933 -1.1067 0.6951691099491193 0.6951686895515568 -4.6229698903721417e-07 -0.0933039196721206 -1.1068 0.6951726408276135 0.695172229089451 -4.533870423123476e-07 -0.09330588573054995 -1.1069 0.6951761707811983 0.6951757675122179 -4.4438770461369126e-07 -0.09330785123170365 -1.107 0.695179699811074 0.6951793048192141 -4.35301005241584e-07 -0.09330981617572796 -1.1071000000000002 0.6951832279184187 0.6951828410098178 -4.261289925922007e-07 -0.09331178056276901 -1.1072 0.6951867551043895 0.6951863760834291 -4.168737335330519e-07 -0.09331374439297302 -1.1073 0.6951902813701212 0.6951899100394697 -4.075373130421611e-07 -0.09331570766648606 -1.1074000000000002 0.6951938067167259 0.6951934428773839 -3.981218337570369e-07 -0.0933176703834543 -1.1075 0.6951973311452939 0.695196974596638 -3.886294154265002e-07 -0.09331963254402377 -1.1076000000000001 0.6952008546568922 0.6952005051967205 -3.790621944457784e-07 -0.0933215941483405 -1.1077000000000001 0.6952043772525653 0.6952040346771435 -3.694223233846605e-07 -0.09332355519655053 -1.1078 0.6952078989333347 0.6952075630374415 -3.597119705642249e-07 -0.0933255156887998 -1.1079 0.6952114197001986 0.6952110902771713 -3.4993331950172735e-07 -0.09332747562523425 -1.108 0.695214939554132 0.6952146163959136 -3.400885684040622e-07 -0.09332943500599973 -1.1081 0.6952184584960868 0.6952181413932729 -3.3017992970285626e-07 -0.09333139383124223 -1.1082 0.6952219765269911 0.6952216652688759 -3.202096296103796e-07 -0.09333335210110758 -1.1083 0.6952254936477493 0.6952251880223734 -3.101799075158618e-07 -0.09333530981574155 -1.1084 0.6952290098592417 0.6952287096534406 -3.0009301556915835e-07 -0.09333726697528996 -1.1085 0.6952325251623246 0.6952322301617757 -2.8995121816727254e-07 -0.09333922357989854 -1.1086 0.6952360395578303 0.6952357495471011 -2.797567913680188e-07 -0.093341179629713 -1.1087 0.6952395530465674 0.6952392678091635 -2.695120224667502e-07 -0.09334313512487906 -1.1088 0.6952430656293194 0.6952427849477336 -2.592192094343082e-07 -0.09334509006554237 -1.1089 0.6952465773068457 0.6952463009626063 -2.4888066043129986e-07 -0.09334704445184855 -1.109 0.6952500880798811 0.6952498158536012 -2.384986932633948e-07 -0.09334899828394316 -1.1091000000000002 0.6952535979491359 0.6952533296205627 -2.2807563489213312e-07 -0.09335095156197186 -1.1092 0.6952571069152951 0.6952568422633592 -2.176138208902223e-07 -0.09335290428608008 -1.1093 0.6952606149790195 0.6952603537818837 -2.0711559492458953e-07 -0.09335485645641338 -1.1094000000000002 0.6952641221409446 0.6952638641760546 -1.965833082290258e-07 -0.09335680807311716 -1.1095 0.6952676284016814 0.6952673734458148 -1.8601931909417724e-07 -0.09335875913633696 -1.1096000000000001 0.6952711337618152 0.695270881591132 -1.7542599232978073e-07 -0.09336070964621807 -1.1097000000000001 0.6952746382219068 0.6952743886119994 -1.6480569871302198e-07 -0.09336265960290599 -1.1098 0.6952781417824915 0.6952778945084348 -1.5416081447505725e-07 -0.09336460900654597 -1.1099 0.6952816444440795 0.695281399280481 -1.4349372080314782e-07 -0.09336655785728343 -1.11 0.6952851462071552 0.695284902928206 -1.328068032647317e-07 -0.09336850615526349 -1.1101 0.695288647072179 0.6952884054517032 -1.2210245126792474e-07 -0.09337045390063155 -1.1102 0.6952921470395844 0.6952919068510912 -1.1138305756538958e-07 -0.09337240109353274 -1.1103 0.6952956461097806 0.6952954071265136 -1.0065101770269369e-07 -0.0933743477341123 -1.1104 0.6952991442831509 0.6952989062781395 -8.990872947187145e-08 -0.09337629382251533 -1.1105 0.6953026415600532 0.6953024043061629 -7.915859239100709e-08 -0.09337823935888698 -1.1106 0.6953061379408204 0.6953059012108035 -6.840300715866415e-08 -0.09338018434337234 -1.1107 0.6953096334257597 0.6953093969923064 -5.764437512219278e-08 -0.09338212877611653 -1.1108 0.6953131280151524 0.6953128916509418 -4.6885097737797005e-08 -0.0933840726572645 -1.1109 0.6953166217092552 0.6953163851870048 -3.612757604388355e-08 -0.09338601598696127 -1.111 0.6953201145082991 0.6953198776008164 -2.5374210116738127e-08 -0.09338795876535187 -1.1111000000000002 0.6953236064124891 0.6953233688927227 -1.4627398537206404e-08 -0.09338990099258117 -1.1112 0.6953270974220054 0.695326859063095 -3.889537856724412e-09 -0.09339184266879408 -1.1113 0.6953305875370028 0.6953303481123295 6.8369779377894235e-09 -0.09339378379413546 -1.1114000000000002 0.695334076757611 0.6953338360408483 1.7549757958500167e-08 -0.09339572436875022 -1.1115 0.6953375650839337 0.695337322849098 2.8246414944879672e-08 -0.09339766439278309 -1.1116000000000001 0.6953410525160497 0.6953408085375508 3.8924565810144474e-08 -0.09339960386637891 -1.1117000000000001 0.6953445390540132 0.6953442931067035 4.958183214345824e-08 -0.09340154278968238 -1.1118 0.6953480246978523 0.6953477765570784 6.021584077545161e-08 -0.09340348116283828 -1.1119 0.6953515094475707 0.6953512588892219 7.082422428389412e-08 -0.09340541898599121 -1.112 0.6953549933031468 0.6953547401037066 8.140462151064176e-08 -0.09340735625928588 -1.1121 0.6953584762645342 0.6953582202011289 9.195467812542213e-08 -0.09340929298286696 -1.1122 0.6953619583316613 0.6953616991821101 1.02472047111557e-07 -0.09341122915687897 -1.1122999999999998 0.6953654395044321 0.6953651770472962 1.1295438931066548e-07 -0.09341316478146641 -1.1124 0.6953689197827257 0.6953686537973579 1.2339937394134637e-07 -0.09341509985677396 -1.1125 0.6953723991663969 0.69537212943299 1.3380467909704374e-07 -0.09341703438294596 -1.1126 0.6953758776552756 0.6953756039549124 1.4416799227687238e-07 -0.09341896836012697 -1.1127 0.6953793552491676 0.6953790773638685 1.5448701091991257e-07 -0.09342090178846142 -1.1128 0.6953828319478543 0.6953825496606262 1.6475944288052435e-07 -0.0934228346680937 -1.1129 0.6953863077510931 0.6953860208459774 1.74983006952234e-07 -0.0934247669991682 -1.113 0.6953897826586171 0.6953894909207378 1.8515543341243723e-07 -0.09342669878182924 -1.1131000000000002 0.6953932566701355 0.6953929598857471 1.952744644283244e-07 -0.09342863001622115 -1.1132 0.6953967297853341 0.6953964277418683 2.0533785465015608e-07 -0.09343056070248817 -1.1133 0.6954002020038745 0.6953998944899882 2.1534337170392437e-07 -0.0934324908407746 -1.1134000000000002 0.695403673325395 0.6954033601310172 2.2528879661115608e-07 -0.09343442043122462 -1.1135 0.6954071437495108 0.6954068246658884 2.3517192441341317e-07 -0.09343634947398244 -1.1136000000000001 0.6954106132758135 0.6954102880955582 2.449905644741346e-07 -0.09343827796919216 -1.1137000000000001 0.695414081903872 0.6954137504210058 2.547425411655868e-07 -0.09344020591699795 -1.1138 0.695417549633232 0.6954172116432337 2.6442569418111406e-07 -0.09344213331754388 -1.1139000000000001 0.6954210164634166 0.6954206717632663 2.740378791665776e-07 -0.093444060170974 -1.114 0.6954244823939264 0.6954241307821507 2.83576968039545e-07 -0.09344598647743235 -1.1141 0.6954279474242399 0.6954275887009567 2.9304084957909593e-07 -0.09344791223706296 -1.1142 0.6954314115538126 0.6954310455207748 3.0242742985603366e-07 -0.09344983745000973 -1.1142999999999998 0.6954348747820789 0.695434501242719 3.11734632697791e-07 -0.09345176211641665 -1.1144 0.6954383371084507 0.695437955867924 3.209604001255806e-07 -0.09345368623642758 -1.1145 0.6954417985323189 0.6954414093975463 3.301026928401174e-07 -0.09345560981018643 -1.1146 0.6954452590530525 0.6954448618327636 3.3915949066570805e-07 -0.09345753283783705 -1.1147 0.6954487186699998 0.6954483131747745 3.481287929388288e-07 -0.09345945531952321 -1.1148 0.6954521773824873 0.6954517634247988 3.570086190909927e-07 -0.09346137725538871 -1.1149 0.6954556351898216 0.6954552125840766 3.6579700894712186e-07 -0.09346329864557727 -1.115 0.6954590920912884 0.6954586606538686 3.744920231973925e-07 -0.09346521949023265 -1.1151000000000002 0.6954625480861528 0.6954621076354557 3.830917438898962e-07 -0.09346713978949849 -1.1152 0.69546600317366 0.6954655535301388 3.915942747637069e-07 -0.09346905954351843 -1.1153 0.6954694573530359 0.6954689983392384 3.999977416860312e-07 -0.09347097875243617 -1.1154000000000002 0.6954729106234856 0.6954724420640948 4.0830029311711424e-07 -0.09347289741639522 -1.1155 0.695476362984196 0.6954758847060668 4.1650010048494e-07 -0.0934748155355392 -1.1156000000000001 0.6954798144343339 0.6954793262665332 4.2459535861544273e-07 -0.09347673311001156 -1.1157000000000001 0.695483264973048 0.695482766746891 4.3258428605169597e-07 -0.09347865013995586 -1.1158 0.6954867145994676 0.6954862061485556 4.4046512550494077e-07 -0.09348056662551554 -1.1159000000000001 0.6954901633127046 0.6954896444729609 4.482361442778582e-07 -0.09348248256683404 -1.116 0.6954936111118519 0.695493081721559 4.558956345768195e-07 -0.09348439796405478 -1.1161 0.6954970579959849 0.695496517895819 4.6344191394209755e-07 -0.09348631281732113 -1.1162 0.6955005039641617 0.695499952997228 4.708733255393005e-07 -0.09348822712677642 -1.1162999999999998 0.6955039490154223 0.69550338702729 4.781882386728498e-07 -0.09349014089256391 -1.1164 0.695507393148791 0.6955068199875263 4.853850488761857e-07 -0.09349205411482697 -1.1165 0.6955108363632742 0.695510251879474 4.924621785640237e-07 -0.0934939667937088 -1.1166 0.6955142786578621 0.695513682704687 4.994180772127654e-07 -0.0934958789293526 -1.1167 0.695517720031529 0.6955171124647358 5.062512217490767e-07 -0.09349779052190157 -1.1168 0.6955211604832334 0.6955205411612055 5.129601168829545e-07 -0.09349970157149884 -1.1169 0.6955246000119182 0.6955239687956976 5.195432953991608e-07 -0.09350161207828761 -1.117 0.6955280386165104 0.6955273953698278 5.259993184764111e-07 -0.09350352204241089 -1.1171000000000002 0.6955314762959228 0.6955308208852273 5.323267760898309e-07 -0.09350543146401175 -1.1172 0.6955349130490533 0.6955342453435421 5.38524287219122e-07 -0.09350734034323324 -1.1173 0.6955383488747857 0.6955376687464315 5.445905002093854e-07 -0.09350924868021836 -1.1174000000000002 0.6955417837719893 0.6955410910955693 5.505240930070432e-07 -0.09351115647511005 -1.1175 0.6955452177395198 0.6955445123926428 5.563237735761728e-07 -0.09351306372805125 -1.1176000000000001 0.6955486507762199 0.6955479326393526 5.619882799540177e-07 -0.09351497043918489 -1.1177000000000001 0.6955520828809185 0.6955513518374119 5.675163807783434e-07 -0.09351687660865382 -1.1178 0.6955555140524327 0.6955547699885472 5.729068753568267e-07 -0.09351878223660089 -1.1179000000000001 0.6955589442895664 0.6955581870944963 5.781585941250222e-07 -0.09352068732316893 -1.118 0.695562373591112 0.6955616031570103 5.83270398632485e-07 -0.09352259186850072 -1.1181 0.6955658019558493 0.6955650181778503 5.882411820701261e-07 -0.09352449587273894 -1.1182 0.6955692293825476 0.69556843215879 5.930698693257241e-07 -0.09352639933602637 -1.1182999999999998 0.6955726558699646 0.6955718451016135 5.977554173031141e-07 -0.09352830225850566 -1.1184 0.6955760814168475 0.6955752570081156 6.022968151303543e-07 -0.09353020464031947 -1.1185 0.695579506021933 0.6955786678801014 6.066930843401375e-07 -0.09353210648161048 -1.1186 0.6955829296839475 0.6955820777193857 6.109432790502023e-07 -0.0935340077825212 -1.1187 0.6955863524016084 0.6955854865277933 6.150464863519112e-07 -0.09353590854319427 -1.1188 0.6955897741736227 0.695588894307158 6.190018263241281e-07 -0.09353780876377214 -1.1189 0.6955931949986893 0.6955923010593222 6.228084522552635e-07 -0.09353970844439737 -1.119 0.695596614875498 0.6955957067861371 6.264655508514405e-07 -0.09354160758521235 -1.1191000000000002 0.6956000338027305 0.6955991114894625 6.299723424585402e-07 -0.0935435061863596 -1.1192 0.6956034517790604 0.6956025151711653 6.3332808113159e-07 -0.09354540424798151 -1.1193 0.6956068688031537 0.6956059178331199 6.365320548290532e-07 -0.0935473017702204 -1.1194000000000002 0.6956102848736696 0.6956093194772083 6.395835856348731e-07 -0.09354919875321867 -1.1195 0.6956136999892599 0.6956127201053187 6.424820298001066e-07 -0.09355109519711861 -1.1196000000000002 0.6956171141485699 0.695616119719346 6.452267778539467e-07 -0.09355299110206246 -1.1197000000000001 0.6956205273502392 0.6956195183211913 6.478172549784222e-07 -0.09355488646819254 -1.1198 0.6956239395929016 0.6956229159127606 6.502529207447205e-07 -0.09355678129565105 -1.1199000000000001 0.6956273508751849 0.6956263124959658 6.525332695156427e-07 -0.09355867558458014 -1.12 0.6956307611957127 0.6956297080727236 6.546578305566264e-07 -0.09356056933512202 -1.1201 0.6956341705531034 0.695633102644955 6.566261679108454e-07 -0.09356246254741879 -1.1202 0.6956375789459708 0.6956364962145856 6.584378806351321e-07 -0.09356435522161252 -1.1202999999999999 0.6956409863729258 0.695639888783544 6.600926029248777e-07 -0.0935662473578453 -1.1204 0.6956443928325746 0.6956432803537631 6.615900041556655e-07 -0.09356813895625915 -1.1205 0.6956477983235214 0.6956466709271787 6.629297887861263e-07 -0.09357003001699613 -1.1206 0.6956512028443662 0.6956500605057284 6.641116966771277e-07 -0.09357192054019808 -1.1207 0.6956546063937077 0.6956534490913533 6.651355029946293e-07 -0.09357381052600705 -1.1208 0.6956580089701421 0.6956568366859959 6.660010181819276e-07 -0.0935756999745649 -1.1209 0.695661410572264 0.6956602232915998 6.667080882372112e-07 -0.09357758888601353 -1.121 0.695664811198667 0.6956636089101107 6.672565944221276e-07 -0.09357947726049479 -1.1211000000000002 0.6956682108479427 0.6956669935434743 6.676464536503612e-07 -0.09358136509815043 -1.1212 0.6956716095186835 0.6956703771936372 6.678776180851775e-07 -0.09358325239912231 -1.1213 0.6956750072094808 0.695673759862546 6.679500754724899e-07 -0.09358513916355216 -1.1214000000000002 0.6956784039189262 0.6956771415521465 6.678638490159594e-07 -0.09358702539158166 -1.1215 0.6956817996456122 0.6956805222643849 6.676189972243396e-07 -0.09358891108335256 -1.1216000000000002 0.6956851943881321 0.6956839020012049 6.672156142445429e-07 -0.09359079623900647 -1.1217000000000001 0.6956885881450801 0.6956872807645498 6.666538294175517e-07 -0.09359268085868501 -1.1218 0.6956919809150528 0.695690658556361 6.659338076253629e-07 -0.09359456494252985 -1.1219000000000001 0.6956953726966486 0.6956940353785772 6.650557488468989e-07 -0.0935964484906825 -1.122 0.6956987634884682 0.6956974112331347 6.640198885465853e-07 -0.09359833150328446 -1.1221 0.695702153289115 0.6957007861219673 6.628264971886288e-07 -0.0936002139804773 -1.1222 0.6957055420971958 0.6957041600470052 6.614758804729393e-07 -0.09360209592240246 -1.1222999999999999 0.6957089299113209 0.6957075330101747 6.599683791685962e-07 -0.09360397732920138 -1.1224 0.6957123167301046 0.6957109050133985 6.583043688918044e-07 -0.0936058582010155 -1.1225 0.6957157025521652 0.6957142760585946 6.56484260300183e-07 -0.0936077385379862 -1.1226 0.6957190873761261 0.6957176461476761 6.545084987319427e-07 -0.09360961834025477 -1.1227 0.6957224712006154 0.6957210152825513 6.523775641503748e-07 -0.09361149760796263 -1.1228 0.6957258540242661 0.6957243834651228 6.500919711716069e-07 -0.09361337634125096 -1.1229 0.6957292358457181 0.6957277506972872 6.47652268773169e-07 -0.09361525454026108 -1.123 0.6957326166636166 0.695731116980935 6.45059040280116e-07 -0.09361713220513418 -1.1231000000000002 0.6957359964766133 0.6957344823179501 6.423129030735941e-07 -0.09361900933601144 -1.1232 0.695739375283367 0.6957378467102096 6.394145087573744e-07 -0.09362088593303404 -1.1233 0.6957427530825435 0.695741210159583 6.363645425888631e-07 -0.09362276199634313 -1.1234000000000002 0.6957461298728163 0.6957445726679324 6.331637236872689e-07 -0.0936246375260798 -1.1235 0.6957495056528669 0.6957479342371116 6.298128045756357e-07 -0.09362651252238513 -1.1236000000000002 0.6957528804213843 0.6957512948689659 6.263125711947204e-07 -0.0936283869854001 -1.1237000000000001 0.6957562541770672 0.6957546545653324 6.226638426670705e-07 -0.09363026091526579 -1.1238 0.6957596269186226 0.6957580133280388 6.188674711027353e-07 -0.09363213431212312 -1.1239000000000001 0.6957629986447669 0.6957613711589032 6.14924341307832e-07 -0.0936340071761131 -1.124 0.6957663693542262 0.6957647280597341 6.108353708261793e-07 -0.09363587950737656 -1.1241 0.6957697390457364 0.6957680840323303 6.066015094119415e-07 -0.09363775130605445 -1.1242 0.6957731077180437 0.6957714390784795 6.02223739099017e-07 -0.09363962257228758 -1.1242999999999999 0.6957764753699056 0.6957747931999587 5.977030737708278e-07 -0.09364149330621681 -1.1244 0.6957798420000898 0.6957781463985342 5.93040559049296e-07 -0.09364336350798289 -1.1245 0.6957832076073759 0.6957814986759605 5.882372719201445e-07 -0.0936452331777266 -1.1246 0.6957865721905545 0.6957848500339805 5.832943205941188e-07 -0.09364710231558868 -1.1247 0.6957899357484292 0.6957882004743243 5.782128443126977e-07 -0.09364897092170979 -1.1248 0.695793298279815 0.695791549998711 5.729940128623712e-07 -0.09365083899623067 -1.1249 0.6957966597835397 0.6957948986088454 5.676390265330067e-07 -0.09365270653929186 -1.125 0.6958000202584443 0.6957982463064201 5.621491157847824e-07 -0.09365457355103401 -1.1251000000000002 0.6958033797033831 0.6958015930931141 5.565255408318537e-07 -0.09365644003159772 -1.1252 0.6958067381172238 0.6958049389705929 5.507695915313304e-07 -0.09365830598112351 -1.1253 0.695810095498848 0.6958082839405075 5.448825869669438e-07 -0.09366017139975191 -1.1254000000000002 0.6958134518471515 0.6958116280044948 5.388658752408793e-07 -0.09366203628762333 -1.1255 0.6958168071610444 0.6958149711641771 5.327208330990763e-07 -0.09366390064487827 -1.1256000000000002 0.6958201614394521 0.695818313421162 5.26448865625917e-07 -0.09366576447165714 -1.1257000000000001 0.6958235146813148 0.6958216547770417 5.20051405938915e-07 -0.09366762776810035 -1.1258 0.6958268668855878 0.6958249952333926 5.135299148556483e-07 -0.09366949053434821 -1.1259000000000001 0.6958302180512429 0.6958283347917757 5.06885880588448e-07 -0.09367135277054112 -1.126 0.6958335681772669 0.6958316734537358 5.001208183003092e-07 -0.0936732144768193 -1.1261 0.6958369172626633 0.6958350112208009 4.93236269966113e-07 -0.093675075653323 -1.1262 0.6958402653064524 0.6958383480944831 4.862338038175151e-07 -0.09367693630019254 -1.1262999999999999 0.6958436123076708 0.6958416840762771 4.791150140653899e-07 -0.09367879641756804 -1.1264 0.6958469582653724 0.6958450191676606 4.7188152052513033e-07 -0.09368065600558977 -1.1265 0.6958503031786283 0.6958483533700939 4.6453496832521424e-07 -0.09368251506439779 -1.1266 0.6958536470465273 0.695851686685019 4.5707702739372635e-07 -0.09368437359413223 -1.1267 0.6958569898681763 0.6958550191138605 4.49509392208558e-07 -0.09368623159493317 -1.1268 0.6958603316426998 0.6958583506580245 4.418337812908679e-07 -0.0936880890669406 -1.1269 0.6958636723692412 0.6958616813188989 4.3405193697609867e-07 -0.09368994601029464 -1.127 0.695867012046962 0.6958650110978525 4.2616562481723186e-07 -0.09369180242513522 -1.1271000000000002 0.6958703506750428 0.6958683399962353 4.181766334321324e-07 -0.0936936583116023 -1.1272 0.6958736882526833 0.695871668015378 4.10086773823537e-07 -0.0936955136698358 -1.1273 0.6958770247791027 0.6958749951565923 4.0189787917088715e-07 -0.09369736849997563 -1.1274000000000002 0.6958803602535393 0.6958783214211692 3.9361180437236243e-07 -0.09369922280216163 -1.1275 0.6958836946752518 0.6958816468103809 3.8523042554527986e-07 -0.09370107657653368 -1.1276000000000002 0.6958870280435181 0.6958849713254786 3.7675563969302717e-07 -0.0937029298232315 -1.1277000000000001 0.6958903603576367 0.6958882949676937 3.681893642332179e-07 -0.09370478254239485 -1.1278 0.6958936916169272 0.695891617738237 3.595335365952357e-07 -0.09370663473416363 -1.1279000000000001 0.6958970218207284 0.6958949396382985 3.5079011372063373e-07 -0.09370848639867735 -1.128 0.695900350968401 0.6958982606690468 3.419610716884347e-07 -0.09371033753607576 -1.1281 0.6959036790593269 0.69590158083163 3.330484052571636e-07 -0.09371218814649854 -1.1282 0.6959070060929083 0.6959049001271747 3.240541273652475e-07 -0.0937140382300853 -1.1282999999999999 0.6959103320685697 0.6959082185567853 3.1498026873549856e-07 -0.0937158877869756 -1.1284 0.6959136569857565 0.6959115361215455 3.0582887739633025e-07 -0.09371773681730906 -1.1285 0.695916980843936 0.6959148528225165 2.9660201816827936e-07 -0.09371958532122508 -1.1286 0.695920303642598 0.695918168660737 2.8730177231012233e-07 -0.09372143329886318 -1.1287 0.6959236253812537 0.6959214836372245 2.7793023694988594e-07 -0.09372328075036285 -1.1288 0.6959269460594374 0.6959247977529737 2.684895246893304e-07 -0.09372512767586359 -1.1289 0.695930265676705 0.6959281110089561 2.5898176300720444e-07 -0.09372697407550473 -1.129 0.6959335842326354 0.6959314234061211 2.494090939331173e-07 -0.09372881994942563 -1.1291000000000002 0.69593690172683 0.6959347349453953 2.397736734716105e-07 -0.09373066529776558 -1.1292 0.6959402181589134 0.6959380456276817 2.300776711233743e-07 -0.09373251012066397 -1.1293 0.6959435335285333 0.695941355453861 2.2032326944115832e-07 -0.0937343544182601 -1.1294000000000002 0.6959468478353602 0.6959446644247902 2.1051266346772124e-07 -0.09373619819069319 -1.1295 0.6959501610790877 0.6959479725413027 2.00648060326436e-07 -0.09373804143810238 -1.1296000000000002 0.6959534732594332 0.6959512798042086 1.9073167864883112e-07 -0.09373988416062691 -1.1297000000000001 0.6959567843761378 0.6959545862142941 1.8076574813397084e-07 -0.09374172635840591 -1.1298 0.6959600944289657 0.6959578917723218 1.7075250903497707e-07 -0.09374356803157852 -1.1299000000000001 0.6959634034177049 0.6959611964790309 1.6069421159697894e-07 -0.09374540918028379 -1.13 0.6959667113421675 0.695964500335136 1.505931156373097e-07 -0.09374724980466084 -1.1301 0.6959700182021898 0.6959678033413279 1.4045148998345636e-07 -0.0937490899048487 -1.1302 0.6959733239976316 0.6959711054982731 1.3027161197345927e-07 -0.09375092948098634 -1.1302999999999999 0.6959766287283765 0.6959744068066143 1.200557669701896e-07 -0.09375276853321272 -1.1304 0.6959799323943332 0.6959777072669692 1.0980624780623782e-07 -0.09375460706166681 -1.1305 0.6959832349954342 0.6959810068799316 9.952535430166054e-08 -0.09375644506648748 -1.1306 0.695986536531636 0.6959843056460708 8.921539276091073e-08 -0.09375828254781361 -1.1307 0.6959898370029202 0.6959876035659315 7.887867539690951e-08 -0.09376011950578408 -1.1308 0.6959931364092923 0.6959909006400338 6.85175198661403e-08 -0.09376195594053767 -1.1309 0.6959964347507823 0.6959941968688732 5.813424873782336e-08 -0.09376379185221317 -1.131 0.6959997320274453 0.6959974922529206 4.773118896135575e-08 -0.09376562724094936 -1.1311000000000002 0.69600302823936 0.6960007867926223 3.7310671345894275e-08 -0.09376746210688493 -1.1312 0.6960063233866307 0.6960040804883993 2.687503005555092e-08 -0.09376929645015857 -1.1313 0.6960096174693858 0.6960073733406487 1.642660205948554e-08 -0.09377113027090894 -1.1314000000000002 0.6960129104877786 0.6960106653497417 5.967726641846471e-09 -0.09377296356927464 -1.1315 0.696016202441987 0.6960139565160255 -4.499255151606263e-09 -0.09377479634539432 -1.1316000000000002 0.6960194933322137 0.6960172468398222 -1.4972001021774928e-08 -0.09377662859940653 -1.1317000000000002 0.6960227831586863 0.6960205363214294 -2.5448167944881056e-08 -0.09377846033144983 -1.1318 0.6960260719216562 0.6960238249611194 -3.592541269223197e-08 -0.09378029154166272 -1.1319000000000001 0.6960293596214006 0.6960271127591395 -4.6401392361317215e-08 -0.09378212223018359 -1.132 0.6960326462582208 0.6960303997157129 -5.6873764895954554e-08 -0.09378395239715098 -1.1321 0.6960359318324434 0.6960336858310374 -6.734018960941751e-08 -0.09378578204270331 -1.1322 0.6960392163444188 0.6960369711052865 -7.779832770712924e-08 -0.09378761116697894 -1.1322999999999999 0.6960424997945223 0.696040255538608 -8.824584281277165e-08 -0.09378943977011618 -1.1324 0.6960457821831543 0.6960435391311259 -9.868040148214297e-08 -0.09379126785225338 -1.1325 0.6960490635107397 0.6960468218829392 -1.0909967373875368e-07 -0.09379309541352886 -1.1326 0.696052343777727 0.6960501037941218 -1.1950133357516157e-07 -0.09379492245408079 -1.1327 0.6960556229845904 0.6960533848647239 -1.2988305949507284e-07 -0.09379674897404751 -1.1328 0.6960589011318281 0.6960566650947705 -1.4024253501034034e-07 -0.09379857497356717 -1.1329 0.6960621782199621 0.6960599444842619 -1.5057744916571747e-07 -0.09380040045277789 -1.133 0.6960654542495396 0.6960632230331745 -1.6088549705840782e-07 -0.0938022254118179 -1.1331000000000002 0.6960687292211316 0.69606650074146 -1.7116438033766557e-07 -0.09380404985082524 -1.1332 0.6960720031353334 0.6960697776090461 -1.8141180773909027e-07 -0.09380587376993804 -1.1333 0.6960752759927639 0.6960730536358362 -1.9162549559637032e-07 -0.09380769716929432 -1.1334000000000002 0.6960785477940667 0.6960763288217091 -2.0180316830792355e-07 -0.09380952004903209 -1.1335 0.696081818539909 0.6960796031665204 -2.1194255890935598e-07 -0.09381134240928934 -1.1336000000000002 0.6960850882309816 0.6960828766701006 -2.220414095227552e-07 -0.09381316425020396 -1.1337000000000002 0.6960883568679994 0.6960861493322577 -2.3209747188057683e-07 -0.09381498557191398 -1.1338 0.6960916244517008 0.6960894211527747 -2.421085078356533e-07 -0.0938168063745572 -1.1339000000000001 0.6960948909828476 0.6960926921314122 -2.5207228984344687e-07 -0.09381862665827152 -1.134 0.6960981564622248 0.6960959622679066 -2.61986601468589e-07 -0.09382044642319481 -1.1341 0.6961014208906411 0.696099231561971 -2.718492378636639e-07 -0.0938222656694648 -1.1342 0.6961046842689278 0.696102500013295 -2.816580062861562e-07 -0.09382408439721932 -1.1342999999999999 0.6961079465979395 0.6961057676215454 -2.914107265737653e-07 -0.09382590260659601 -1.1344 0.6961112078785539 0.6961090343863661 -3.011052316023721e-07 -0.09382772029773266 -1.1345 0.6961144681116707 0.6961123003073779 -3.107393677925785e-07 -0.09382953747076689 -1.1346 0.6961177272982132 0.6961155653841793 -3.2031099559542975e-07 -0.09383135412583647 -1.1347 0.696120985439126 0.6961188296163459 -3.298179899954845e-07 -0.09383317026307891 -1.1348 0.6961242425353764 0.6961220930034311 -3.392582408820455e-07 -0.09383498588263178 -1.1349 0.6961274985879542 0.696125355544966 -3.486296536250877e-07 -0.09383680098463272 -1.135 0.6961307535978705 0.6961286172404594 -3.579301494846532e-07 -0.09383861556921916 -1.1351000000000002 0.6961340075661584 0.6961318780893988 -3.6715766606881806e-07 -0.09384042963652867 -1.1352 0.6961372604938725 0.6961351380912495 -3.763101578471706e-07 -0.0938422431866986 -1.1353 0.6961405123820891 0.6961383972454558 -3.8538559648387816e-07 -0.09384405621986656 -1.1354000000000002 0.6961437632319054 0.6961416555514401 -3.943819714621877e-07 -0.09384586873616985 -1.1355 0.6961470130444394 0.6961449130086039 -4.0329729038973694e-07 -0.09384768073574581 -1.1356000000000002 0.6961502618208302 0.6961481696163281 -4.1212957951203277e-07 -0.09384949221873179 -1.1357000000000002 0.6961535095622376 0.6961514253739723 -4.208768840732735e-07 -0.09385130318526518 -1.1358 0.6961567562698417 0.6961546802808761 -4.295372688506438e-07 -0.0938531136354832 -1.1359000000000001 0.6961600019448425 0.6961579343363583 -4.381088184735038e-07 -0.09385492356952305 -1.136 0.6961632465884602 0.6961611875397178 -4.465896379993173e-07 -0.09385673298752197 -1.1361 0.6961664902019351 0.6961644398902336 -4.5497785314263517e-07 -0.0938585418896172 -1.1362 0.6961697327865266 0.6961676913871656 -4.6327161083020707e-07 -0.09386035027594591 -1.1362999999999999 0.6961729743435134 0.6961709420297533 -4.7146907955486483e-07 -0.09386215814664516 -1.1364 0.6961762148741935 0.6961741918172177 -4.795684498404285e-07 -0.09386396550185208 -1.1365 0.6961794543798836 0.6961774407487602 -4.875679345331396e-07 -0.09386577234170373 -1.1366 0.6961826928619187 0.6961806888235644 -4.954657692596287e-07 -0.09386757866633712 -1.1367 0.6961859303216527 0.6961839360407946 -5.032602128293706e-07 -0.09386938447588929 -1.1368 0.6961891667604574 0.6961871823995971 -5.10949547609385e-07 -0.09387118977049717 -1.1369 0.6961924021797221 0.6961904278991005 -5.185320798919979e-07 -0.09387299455029768 -1.137 0.6961956365808544 0.6961936725384152 -5.260061402417859e-07 -0.09387479881542782 -1.1371000000000002 0.6961988699652785 0.6961969163166348 -5.333700839327271e-07 -0.09387660256602441 -1.1372 0.6962021023344362 0.6962001592328354 -5.406222912535119e-07 -0.09387840580222434 -1.1373 0.6962053336897855 0.6962034012860759 -5.477611679099992e-07 -0.0938802085241644 -1.1374000000000002 0.6962085640328017 0.696206642475399 -5.547851452680774e-07 -0.09388201073198138 -1.1375 0.6962117933649759 0.6962098827998306 -5.61692680867143e-07 -0.09388381242581209 -1.1376000000000002 0.6962150216878149 0.696213122258381 -5.684822586421445e-07 -0.0938856136057932 -1.1377000000000002 0.6962182490028415 0.6962163608500439 -5.751523892982835e-07 -0.09388741427206138 -1.1378 0.6962214753115938 0.6962195985737982 -5.817016106024475e-07 -0.09388921442475333 -1.1379000000000001 0.6962247006156256 0.6962228354286079 -5.881284877023996e-07 -0.09389101406400574 -1.138 0.6962279249165044 0.6962260714134209 -5.944316135292338e-07 -0.09389281318995515 -1.1381000000000001 0.6962311482158131 0.696229306527171 -6.006096089916646e-07 -0.09389461180273814 -1.1382 0.6962343705151484 0.696232540768778 -6.066611233368491e-07 -0.09389640990249126 -1.1382999999999999 0.6962375918161211 0.6962357741371475 -6.125848344418205e-07 -0.09389820748935102 -1.1384 0.6962408121203554 0.6962390066311712 -6.183794491187999e-07 -0.09390000456345392 -1.1385 0.6962440314294892 0.6962422382497272 -6.240437033511181e-07 -0.09390180112493642 -1.1386 0.696247249745173 0.6962454689916812 -6.295763626124051e-07 -0.09390359717393497 -1.1387 0.6962504670690701 0.6962486988558849 -6.349762221580235e-07 -0.09390539271058584 -1.1388 0.6962536834028559 0.696251927841179 -6.402421071222131e-07 -0.09390718773502553 -1.1389 0.6962568987482185 0.6962551559463908 -6.453728730315689e-07 -0.0939089822473903 -1.139 0.6962601131068571 0.6962583831703363 -6.50367405888308e-07 -0.09391077624781646 -1.1391000000000002 0.6962633264804823 0.69626160951182 -6.552246223784364e-07 -0.0939125697364403 -1.1392 0.6962665388708162 0.6962648349696353 -6.599434702603268e-07 -0.09391436271339804 -1.1393 0.6962697502795916 0.6962680595425644 -6.645229285312526e-07 -0.09391615517882593 -1.1394000000000002 0.6962729607085509 0.696271283229379 -6.689620075245317e-07 -0.09391794713286006 -1.1395 0.6962761701594478 0.6962745060288411 -6.732597492842274e-07 -0.09391973857563665 -1.1396000000000002 0.6962793786340442 0.6962777279397023 -6.774152277455592e-07 -0.09392152950729178 -1.1397 0.6962825861341129 0.696280948960705 -6.814275488459254e-07 -0.09392331992796157 -1.1398 0.6962857926614351 0.6962841690905823 -6.852958507330698e-07 -0.09392510983778207 -1.1399000000000001 0.6962889982178002 0.6962873883280587 -6.890193041259041e-07 -0.0939268992368893 -1.14 0.6962922028050067 0.6962906066718497 -6.925971122034857e-07 -0.09392868812541921 -1.1401000000000001 0.6962954064248609 0.6962938241206633 -6.960285110629849e-07 -0.09393047650350783 -1.1402 0.6962986090791765 0.6962970406731992 -6.993127697196844e-07 -0.09393226437129104 -1.1402999999999999 0.6963018107697749 0.6963002563281502 -7.024491902318797e-07 -0.09393405172890479 -1.1404 0.6963050114984843 0.6963034710842015 -7.054371079368016e-07 -0.09393583857648496 -1.1405 0.6963082112671395 0.6963066849400318 -7.082758916310272e-07 -0.0939376249141674 -1.1406 0.6963114100775813 0.6963098978943134 -7.10964943514969e-07 -0.09393941074208788 -1.1407 0.6963146079316567 0.6963131099457123 -7.135036995398192e-07 -0.09394119606038216 -1.1408 0.6963178048312182 0.6963163210928894 -7.158916294491835e-07 -0.09394298086918604 -1.1409 0.6963210007781235 0.6963195313345001 -7.181282368207142e-07 -0.09394476516863526 -1.141 0.696324195774235 0.6963227406691942 -7.202130591493772e-07 -0.0939465489588654 -1.1411000000000002 0.6963273898214195 0.696325949095618 -7.221456681250071e-07 -0.09394833224001226 -1.1412 0.6963305829215483 0.696329156612413 -7.239256695490415e-07 -0.0939501150122114 -1.1413 0.6963337750764957 0.6963323632182167 -7.255527035426867e-07 -0.09395189727559841 -1.1414000000000002 0.6963369662881405 0.6963355689116633 -7.270264444220187e-07 -0.09395367903030893 -1.1415 0.696340156558363 0.6963387736913841 -7.283466010449269e-07 -0.09395546027647839 -1.1416000000000002 0.6963433458890476 0.6963419775560072 -7.295129166029479e-07 -0.09395724101424241 -1.1417 0.6963465342820798 0.6963451805041585 -7.305251688294323e-07 -0.09395902124373638 -1.1418 0.6963497217393478 0.6963483825344619 -7.313831699023998e-07 -0.09396080096509578 -1.1419000000000001 0.6963529082627413 0.6963515836455397 -7.32086766680462e-07 -0.09396258017845605 -1.142 0.6963560938541506 0.6963547838360127 -7.32635840647311e-07 -0.09396435888395252 -1.1421000000000001 0.6963592785154675 0.6963579831045006 -7.330303077451861e-07 -0.09396613708172061 -1.1422 0.6963624622485837 0.6963611814496229 -7.332701186940627e-07 -0.09396791477189559 -1.1422999999999999 0.6963656450553913 0.696364378869999 -7.333552587557302e-07 -0.0939696919546128 -1.1424 0.6963688269377821 0.696367575364248 -7.33285747844814e-07 -0.09397146863000748 -1.1425 0.6963720078976471 0.6963707709309896 -7.33061640459387e-07 -0.09397324479821485 -1.1426 0.6963751879368762 0.6963739655688448 -7.326830256809691e-07 -0.09397502045937013 -1.1427 0.6963783670573584 0.6963771592764354 -7.321500272300385e-07 -0.09397679561360853 -1.1428 0.6963815452609806 0.6963803520523852 -7.314628032994985e-07 -0.09397857026106515 -1.1429 0.6963847225496274 0.6963835438953196 -7.306215466101884e-07 -0.09398034440187508 -1.143 0.6963878989251813 0.6963867348038668 -7.296264841888389e-07 -0.09398211803617351 -1.1431000000000002 0.6963910743895219 0.6963899247766572 -7.284778776039946e-07 -0.09398389116409539 -1.1432 0.6963942489445251 0.6963931138123247 -7.271760225913138e-07 -0.09398566378577576 -1.1433 0.6963974225920638 0.6963963019095063 -7.257212492339793e-07 -0.09398743590134961 -1.1434000000000002 0.6964005953340071 0.696399489066843 -7.241139216712655e-07 -0.09398920751095191 -1.1435 0.6964037671722192 0.6964026752829803 -7.22354438167927e-07 -0.0939909786147176 -1.1436000000000002 0.6964069381085601 0.6964058605565675 -7.204432309337871e-07 -0.09399274921278158 -1.1437 0.6964101081448846 0.6964090448862594 -7.183807659849606e-07 -0.09399451930527873 -1.1438 0.6964132772830423 0.6964122282707156 -7.161675431577308e-07 -0.09399628889234385 -1.1439000000000001 0.6964164455248769 0.6964154107086016 -7.138040958726277e-07 -0.09399805797411181 -1.144 0.6964196128722262 0.6964185921985886 -7.112909910927945e-07 -0.09399982655071737 -1.1441000000000001 0.6964227793269213 0.6964217727393542 -7.086288290741871e-07 -0.09400159462229522 -1.1442 0.6964259448907869 0.696424952329583 -7.058182433655746e-07 -0.09400336218898013 -1.1442999999999999 0.6964291095656401 0.696428130967966 -7.028599005309832e-07 -0.09400512925090676 -1.1444 0.696432273353291 0.6964313086532017 -6.997545001358185e-07 -0.0940068958082098 -1.1445 0.6964354362555417 0.6964344853839965 -6.965027744137986e-07 -0.09400866186102382 -1.1446 0.6964385982741861 0.6964376611590652 -6.931054881836873e-07 -0.09401042740948348 -1.1447 0.6964417594110093 0.69644083597713 -6.895634387521499e-07 -0.09401219245372333 -1.1448 0.6964449196677884 0.6964440098369229 -6.85877455497419e-07 -0.09401395699387789 -1.1449 0.6964480790462904 0.6964471827371839 -6.820483999941951e-07 -0.09401572103008171 -1.145 0.6964512375482729 0.6964503546766634 -6.780771655418016e-07 -0.0940174845624692 -1.1451000000000002 0.6964543951754845 0.6964535256541208 -6.739646770254071e-07 -0.09401924759117485 -1.1452 0.6964575519296625 0.6964566956683258 -6.697118907494914e-07 -0.09402101011633303 -1.1453 0.6964607078125343 0.6964598647180588 -6.653197942296796e-07 -0.09402277213807818 -1.1454000000000002 0.6964638628258164 0.6964630328021104 -6.607894059568187e-07 -0.09402453365654462 -1.1455 0.696467016971214 0.6964661999192827 -6.561217750500337e-07 -0.09402629467186668 -1.1456000000000002 0.6964701702504208 0.6964693660683892 -6.513179811734604e-07 -0.0940280551841787 -1.1457 0.6964733226651187 0.6964725312482545 -6.463791341476677e-07 -0.09402981519361489 -1.1458 0.6964764742169776 0.6964756954577156 -6.413063738108793e-07 -0.09403157470030947 -1.1459000000000001 0.6964796249076544 0.6964788586956223 -6.361008697275405e-07 -0.0940333337043967 -1.146 0.696482774738794 0.696482020960836 -6.307638208968847e-07 -0.0940350922060107 -1.1461000000000001 0.6964859237120282 0.6964851822522318 -6.252964553365992e-07 -0.09403685020528563 -1.1462 0.6964890718289747 0.6964883425686978 -6.197000301244593e-07 -0.0940386077023556 -1.1462999999999999 0.6964922190912379 0.696491501909136 -6.139758309126053e-07 -0.09404036469735472 -1.1464 0.6964953655004087 0.6964946602724618 -6.081251715944758e-07 -0.09404212119041702 -1.1465 0.696498511058063 0.6964978176576045 -6.021493939717404e-07 -0.09404387718167652 -1.1466 0.6965016557657626 0.6965009740635089 -5.960498677543002e-07 -0.09404563267126725 -1.1467 0.6965047996250542 0.6965041294891332 -5.898279898247649e-07 -0.09404738765932309 -1.1468 0.6965079426374692 0.6965072839334518 -5.834851842662081e-07 -0.09404914214597802 -1.1469 0.6965110848045241 0.6965104373954537 -5.770229017515449e-07 -0.09405089613136593 -1.147 0.6965142261277193 0.6965135898741435 -5.704426194602652e-07 -0.09405264961562067 -1.1471000000000002 0.6965173666085397 0.6965167413685422 -5.637458406620999e-07 -0.0940544025988762 -1.1472 0.696520506248453 0.696519891877686 -5.569340942590539e-07 -0.09405615508126614 -1.1473 0.6965236450489114 0.6965230414006287 -5.500089345494841e-07 -0.09405790706292438 -1.1474000000000002 0.6965267830113496 0.6965261899364397 -5.429719408533984e-07 -0.09405965854398468 -1.1475 0.6965299201371857 0.6965293374842056 -5.358247172071451e-07 -0.09406140952458072 -1.1476000000000002 0.6965330564278203 0.6965324840430308 -5.285688918638121e-07 -0.09406316000484621 -1.1477 0.6965361918846364 0.6965356296120362 -5.212061170017934e-07 -0.0940649099849148 -1.1478 0.6965393265089993 0.6965387741903608 -5.137380683847836e-07 -0.09406665946492009 -1.1479000000000001 0.6965424603022563 0.6965419177771619 -5.061664449315662e-07 -0.09406840844499573 -1.148 0.6965455932657361 0.6965450603716143 -4.984929683898853e-07 -0.09407015692527526 -1.1481000000000001 0.6965487254007494 0.6965482019729119 -4.907193827952128e-07 -0.09407190490589226 -1.1482 0.6965518567085878 0.6965513425802662 -4.828474542625805e-07 -0.09407365238698018 -1.1482999999999999 0.6965549871905234 0.6965544821929086 -4.748789704384082e-07 -0.09407539936867247 -1.1484 0.6965581168478101 0.6965576208100894 -4.6681574020907e-07 -0.09407714585110265 -1.1485 0.6965612456816821 0.6965607584310776 -4.586595932151716e-07 -0.0940788918344041 -1.1486 0.6965643736933533 0.6965638950551623 -4.504123794421555e-07 -0.09408063731871023 -1.1487 0.6965675008840186 0.6965670306816523 -4.4207596887335665e-07 -0.0940823823041544 -1.1488 0.6965706272548521 0.6965701653098758 -4.3365225096958504e-07 -0.0940841267908699 -1.1489 0.6965737528070081 0.696573298939182 -4.2514313428054784e-07 -0.09408587077899001 -1.149 0.6965768775416203 0.6965764315689398 -4.165505460632102e-07 -0.09408761426864809 -1.1491000000000002 0.6965800014598017 0.6965795631985389 -4.078764317475003e-07 -0.09408935725997732 -1.1492 0.6965831245626446 0.6965826938273896 -3.991227545616094e-07 -0.09409109975311089 -1.1493 0.6965862468512198 0.6965858234549231 -3.9029149510177996e-07 -0.09409284174818196 -1.1494000000000002 0.6965893683265776 0.6965889520805918 -3.8138465083964457e-07 -0.09409458324532372 -1.1495 0.6965924889897465 0.6965920797038694 -3.724042356781365e-07 -0.09409632424466927 -1.1496000000000002 0.6965956088417333 0.6965952063242509 -3.6335227953515625e-07 -0.0940980647463517 -1.1497 0.6965987278835236 0.6965983319412529 -3.542308277953987e-07 -0.09409980475050406 -1.1498 0.6966018461160808 0.6966014565544135 -3.450419409564698e-07 -0.09410154425725939 -1.1499000000000001 0.696604963540346 0.6966045801632934 -3.3578769415010257e-07 -0.09410328326675065 -1.15 0.6966080801572386 0.6966077027674746 -3.264701765870459e-07 -0.09410502177911084 -1.1501000000000001 0.6966111959676555 0.6966108243665619 -3.1709149116848634e-07 -0.09410675979447286 -1.1502000000000001 0.6966143109724707 0.6966139449601821 -3.076537539586921e-07 -0.09410849731296962 -1.1502999999999999 0.6966174251725368 0.6966170645479846 -2.9815909377561844e-07 -0.09411023433473403 -1.1504 0.6966205385686824 0.696620183129641 -2.8860965160804053e-07 -0.09411197085989893 -1.1505 0.6966236511617139 0.6966233007048463 -2.7900758022697536e-07 -0.09411370688859709 -1.1506 0.6966267629524145 0.696626417273318 -2.69355043682612e-07 -0.09411544242096131 -1.1507 0.6966298739415446 0.6966295328347966 -2.59654216780425e-07 -0.09411717745712439 -1.1508 0.6966329841298409 0.6966326473890454 -2.4990728462320755e-07 -0.094118911997219 -1.1509 0.6966360935180173 0.6966357609358514 -2.4011644208024596e-07 -0.09412064604137785 -1.151 0.6966392021067638 0.6966388734750246 -2.302838933640472e-07 -0.0941223795897336 -1.1511000000000002 0.6966423098967476 0.6966419850063983 -2.2041185145441067e-07 -0.0941241126424189 -1.1512 0.6966454168886114 0.6966450955298292 -2.1050253766474736e-07 -0.0941258451995663 -1.1513 0.6966485230829753 0.6966482050451979 -2.0055818108696832e-07 -0.09412757726130844 -1.1514000000000002 0.6966516284804352 0.696651313552408 -1.9058101815086492e-07 -0.09412930882777781 -1.1515 0.6966547330815626 0.6966544210513874 -1.805732920689973e-07 -0.09413103989910694 -1.1516000000000002 0.6966578368869059 0.6966575275420877 -1.7053725236138018e-07 -0.09413277047542834 -1.1517 0.6966609398969896 0.6966606330244839 -1.604751543298616e-07 -0.09413450055687445 -1.1518 0.6966640421123138 0.6966637374985749 -1.5038925857066565e-07 -0.09413623014357769 -1.1519000000000001 0.6966671435333545 0.6966668409643837 -1.402818304557102e-07 -0.09413795923567042 -1.152 0.6966702441605639 0.6966699434219575 -1.301551396399453e-07 -0.09413968783328502 -1.1521000000000001 0.6966733439943699 0.6966730448713674 -1.200114595270585e-07 -0.09414141593655385 -1.1522000000000001 0.6966764430351764 0.6966761453127082 -1.0985306676467022e-07 -0.09414314354560921 -1.1522999999999999 0.6966795412833631 0.6966792447460989 -9.96822407655501e-08 -0.09414487066058336 -1.1524 0.696682638739285 0.6966823431716825 -8.95012631481687e-08 -0.09414659728160847 -1.1525 0.6966857354032739 0.6966854405896268 -7.931241725444432e-08 -0.09414832340881692 -1.1526 0.6966888312756364 0.696688537000123 -6.911798763886701e-08 -0.09415004904234076 -1.1527 0.6966919263566553 0.6966916324033863 -5.892025953680574e-08 -0.09415177418231219 -1.1528 0.696695020646589 0.6966947267996567 -4.872151837184702e-08 -0.09415349882886331 -1.1529 0.6966981141456712 0.6966978201891978 -3.852404923320937e-08 -0.0941552229821262 -1.153 0.6967012068541124 0.6967009125722976 -2.8330136367469422e-08 -0.09415694664223297 -1.1531000000000002 0.6967042987720979 0.696704003949268 -1.814206266595106e-08 -0.09415866980931559 -1.1532 0.6967073898997898 0.696707094320445 -7.96210915341572e-09 -0.09416039248350608 -1.1533 0.696710480237325 0.6967101836861891 2.207445521512641e-09 -0.0941621146649365 -1.1534 0.6967135697848168 0.6967132720468843 1.236432559548889e-08 -0.09416383635373873 -1.1535 0.6967166585423539 0.6967163594029386 2.2506258705659588e-08 -0.09416555755004463 -1.1536000000000002 0.6967197465100018 0.6967194457547843 3.263097638969703e-08 -0.09416727825398616 -1.1537 0.6967228336878011 0.6967225311028771 4.273621460014476e-08 -0.0941689984656951 -1.1538 0.6967259200757687 0.6967256154476971 5.281971420835474e-08 -0.09417071818530331 -1.1539000000000001 0.696729005673898 0.6967286987897481 6.287922149975089e-08 -0.09417243741294261 -1.154 0.6967320904821579 0.6967317811295572 7.29124886977156e-08 -0.09417415614874469 -1.1541000000000001 0.6967351745004939 0.6967348624676757 8.291727445278174e-08 -0.09417587439284135 -1.1542000000000001 0.6967382577288279 0.696737942804678 9.289134433876356e-08 -0.09417759214536425 -1.1542999999999999 0.696741340167058 0.6967410221411625 1.0283247136796958e-07 -0.0941793094064451 -1.1544 0.6967444218150585 0.6967441004777506 1.1273843647519044e-07 -0.09418102617621553 -1.1545 0.6967475026726806 0.6967471778150871 1.2260702901209508e-07 -0.09418274245480714 -1.1546 0.6967505827397515 0.6967502541538404 1.324360472468311e-07 -0.09418445824235148 -1.1547 0.6967536620160765 0.6967533294947017 1.4222329885321683e-07 -0.09418617353898015 -1.1548 0.6967567405014363 0.6967564038383856 1.5196660141381102e-07 -0.0941878883448247 -1.1549 0.6967598181955892 0.6967594771856289 1.6166378287441052e-07 -0.09418960266001657 -1.155 0.6967628950982705 0.696762549537192 1.713126820609978e-07 -0.0941913164846872 -1.1551000000000002 0.6967659712091929 0.6967656208938575 1.8091114914117745e-07 -0.0941930298189681 -1.1552 0.6967690465280456 0.696768691256431 1.904570461133681e-07 -0.0941947426629906 -1.1553 0.6967721210544964 0.69677176062574 1.9994824727864735e-07 -0.0941964550168861 -1.1554 0.6967751947881899 0.6967748290026348 2.093826397125964e-07 -0.09419816688078597 -1.1555 0.6967782677287486 0.6967778963879872 2.1875812374061443e-07 -0.09419987825482147 -1.1556000000000002 0.6967813398757727 0.696780962782692 2.2807261338547713e-07 -0.09420158913912391 -1.1557 0.6967844112288409 0.6967840281876653 2.3732403688081494e-07 -0.09420329953382461 -1.1558 0.6967874817875096 0.6967870926038444 2.4651033707356884e-07 -0.09420500943905467 -1.1559000000000001 0.6967905515513134 0.6967901560321892 2.5562947194440744e-07 -0.09420671885494532 -1.156 0.696793620519766 0.6967932184736803 2.646794149824272e-07 -0.09420842778162775 -1.1561000000000001 0.6967966886923591 0.6967962799293195 2.736581557194473e-07 -0.09421013621923303 -1.1562000000000001 0.6967997560685637 0.6967993404001303 2.825637000908321e-07 -0.09421184416789237 -1.1562999999999999 0.69680282264783 0.6968023998871564 2.9139407097672487e-07 -0.09421355162773683 -1.1564 0.6968058884295869 0.6968054583914622 3.0014730853511473e-07 -0.09421525859889739 -1.1565 0.6968089534132422 0.6968085159141331 3.088214707361314e-07 -0.09421696508150507 -1.1566 0.6968120175981847 0.696811572456274 3.1741463371592893e-07 -0.09421867107569086 -1.1567 0.696815080983782 0.6968146280190108 3.2592489226240806e-07 -0.09422037658158572 -1.1568 0.6968181435693819 0.6968176826034889 3.343503601829778e-07 -0.09422208159932063 -1.1569 0.6968212053543124 0.6968207362108729 3.4268917076946126e-07 -0.09422378612902642 -1.157 0.6968242663378814 0.6968237888423477 3.509394771866736e-07 -0.09422549017083394 -1.1571000000000002 0.6968273265193781 0.6968268404991169 3.590994528887559e-07 -0.09422719372487402 -1.1572 0.6968303858980724 0.6968298911824036 3.671672920077529e-07 -0.09422889679127747 -1.1573 0.6968334444732152 0.6968329408934495 3.751412097907636e-07 -0.0942305993701751 -1.1574 0.6968365022440384 0.6968359896335148 3.830194429677025e-07 -0.09423230146169764 -1.1575 0.6968395592097559 0.6968390374038782 3.9080025014681663e-07 -0.09423400306597583 -1.1576000000000002 0.696842615369563 0.6968420842058367 3.9848191220326346e-07 -0.09423570418314037 -1.1577 0.6968456707226371 0.6968451300407047 4.0606273262605574e-07 -0.09423740481332185 -1.1578 0.6968487252681377 0.6968481749098147 4.135410379482729e-07 -0.09423910495665096 -1.1579000000000002 0.6968517790052068 0.6968512188145164 4.209151781078835e-07 -0.09424080461325823 -1.158 0.6968548319329693 0.6968542617561765 4.281835267530565e-07 -0.09424250378327426 -1.1581000000000001 0.6968578840505328 0.6968573037361789 4.353444816793117e-07 -0.09424420246682957 -1.1582000000000001 0.6968609353569886 0.6968603447559242 4.423964651209533e-07 -0.0942459006640547 -1.1582999999999999 0.6968639858514107 0.6968633848168289 4.4933792417434226e-07 -0.09424759837508004 -1.1584 0.6968670355328581 0.6968664239203259 4.56167331019941e-07 -0.09424929560003613 -1.1585 0.6968700844003728 0.6968694620678643 4.6288318336640266e-07 -0.09425099233905332 -1.1586 0.6968731324529815 0.6968724992609079 4.694840047420046e-07 -0.09425268859226206 -1.1587 0.6968761796896954 0.6968755355009366 4.7596834480689854e-07 -0.09425438435979266 -1.1588 0.6968792261095106 0.6968785707894446 4.82334779727811e-07 -0.09425607964177542 -1.1589 0.6968822717114084 0.6968816051279416 4.885819123723323e-07 -0.09425777443834067 -1.159 0.6968853164943556 0.696884638517951 4.947083728085166e-07 -0.09425946874961871 -1.1591000000000002 0.6968883604573048 0.696887670961011 5.007128183881493e-07 -0.09426116257573976 -1.1592 0.6968914035991944 0.696890702458673 5.065939342324688e-07 -0.09426285591683399 -1.1593 0.6968944459189491 0.6968937330125027 5.123504333154338e-07 -0.09426454877303164 -1.1594 0.6968974874154805 0.6968967626240781 5.179810569494459e-07 -0.09426624114446282 -1.1595 0.6969005280876867 0.6968997912949911 5.234845749241268e-07 -0.0942679330312576 -1.1596000000000002 0.6969035679344534 0.6969028190268457 5.288597858948973e-07 -0.09426962443354615 -1.1597 0.6969066069546538 0.6969058458212585 5.341055175495102e-07 -0.09427131535145851 -1.1598 0.696909645147149 0.6969088716798577 5.392206268439725e-07 -0.09427300578512471 -1.1599000000000002 0.6969126825107879 0.6969118966042838 5.442040003217352e-07 -0.09427469573467472 -1.16 0.6969157190444082 0.6969149205961882 5.490545543357372e-07 -0.09427638520023851 -1.1601000000000001 0.6969187547468362 0.6969179436572338 5.537712353259616e-07 -0.09427807418194603 -1.1602000000000001 0.6969217896168878 0.6969209657890941 5.583530199165798e-07 -0.09427976267992724 -1.1602999999999999 0.6969248236533674 0.6969239869934528 5.627989152490187e-07 -0.09428145069431193 -1.1604 0.6969278568550703 0.6969270072720041 5.671079592595163e-07 -0.09428313822523002 -1.1605 0.696930889220781 0.6969300266264518 5.712792206791217e-07 -0.09428482527281129 -1.1606 0.6969339207492746 0.6969330450585086 5.753117994361512e-07 -0.0942865118371855 -1.1607 0.6969369514393173 0.6969360625698977 5.792048266978211e-07 -0.09428819791848247 -1.1608 0.6969399812896663 0.69693907916235 5.829574652449487e-07 -0.09428988351683197 -1.1609 0.6969430102990699 0.696942094837605 5.865689094164406e-07 -0.09429156863236358 -1.161 0.6969460384662685 0.6969451095974106 5.900383855395042e-07 -0.0942932532652071 -1.1611000000000002 0.696949065789994 0.6969481234435226 5.933651518463812e-07 -0.09429493741549208 -1.1612 0.6969520922689717 0.6969511363777037 5.965484987796588e-07 -0.09429662108334814 -1.1613 0.6969551179019192 0.6969541484017236 5.995877491032919e-07 -0.09429830426890494 -1.1614 0.6969581426875469 0.6969571595173598 6.024822580968925e-07 -0.09429998697229193 -1.1615 0.696961166624559 0.6969601697263952 6.05231413625118e-07 -0.09430166919363868 -1.1616000000000002 0.6969641897116536 0.696963179030619 6.078346362486942e-07 -0.0943033509330747 -1.1617 0.6969672119475229 0.6969661874318267 6.102913794603371e-07 -0.09430503219072943 -1.1618 0.6969702333308534 0.6969691949318181 6.126011296847533e-07 -0.09430671296673232 -1.1619000000000002 0.6969732538603268 0.6969722015323989 6.147634064590513e-07 -0.09430839326121276 -1.162 0.6969762735346198 0.6969752072353792 6.16777762488252e-07 -0.09431007307430014 -1.1621000000000001 0.6969792923524045 0.6969782120425733 6.186437837979453e-07 -0.09431175240612379 -1.1622000000000001 0.6969823103123494 0.6969812159557993 6.203610897204115e-07 -0.09431343125681302 -1.1622999999999999 0.6969853274131188 0.6969842189768795 6.219293330333997e-07 -0.0943151096264971 -1.1624 0.6969883436533741 0.6969872211076388 6.233482000295165e-07 -0.09431678751530533 -1.1625 0.6969913590317733 0.6969902223499056 6.246174105578595e-07 -0.09431846492336697 -1.1626 0.696994373546972 0.69699322270551 6.257367181489171e-07 -0.09432014185081114 -1.1627 0.6969973871976232 0.6969962221762852 6.267059100145689e-07 -0.09432181829776703 -1.1628 0.6970003999823781 0.6969992207640656 6.275248069509409e-07 -0.09432349426436376 -1.1629 0.6970034118998865 0.6970022184706872 6.281932636437171e-07 -0.09432516975073046 -1.163 0.6970064229487964 0.6970052152979873 6.287111684599722e-07 -0.0943268447569962 -1.1631000000000002 0.6970094331277561 0.6970082112478038 6.290784435730723e-07 -0.09432851928329 -1.1632 0.697012442435412 0.6970112063219751 6.292950449765522e-07 -0.09433019332974098 -1.1633 0.6970154508704114 0.6970142005223394 6.293609624979934e-07 -0.09433186689647804 -1.1634 0.6970184584314009 0.6970171938507346 6.292762196741242e-07 -0.09433353998363009 -1.1635 0.6970214651170283 0.6970201863089982 6.29040873820208e-07 -0.09433521259132613 -1.1636000000000002 0.6970244709259427 0.6970231778989666 6.286550160855553e-07 -0.09433688471969509 -1.1637 0.6970274758567934 0.6970261686224748 6.281187712869896e-07 -0.09433855636886584 -1.1638 0.6970304799082319 0.6970291584813556 6.274322979782365e-07 -0.09434022753896716 -1.1639000000000002 0.6970334830789119 0.6970321474774401 6.265957883666573e-07 -0.0943418982301279 -1.164 0.6970364853674886 0.6970351356125573 6.25609468216104e-07 -0.0943435684424768 -1.1641000000000001 0.6970394867726213 0.6970381228885325 6.244735968191639e-07 -0.09434523817614265 -1.1642000000000001 0.697042487292971 0.6970411093071883 6.231884669832821e-07 -0.09434690743125417 -1.1643 0.6970454869272031 0.6970440948703438 6.217544049336166e-07 -0.09434857620794004 -1.1644 0.6970484856739858 0.6970470795798143 6.201717702158938e-07 -0.09435024450632891 -1.1645 0.6970514835319923 0.6970500634374106 6.184409555437531e-07 -0.09435191232654941 -1.1646 0.6970544804998997 0.6970530464449392 6.165623867709913e-07 -0.09435357966873019 -1.1647 0.6970574765763904 0.6970560286042013 6.145365228638067e-07 -0.0943552465329998 -1.1648 0.6970604717601513 0.6970590099169933 6.123638556371214e-07 -0.09435691291948678 -1.1649 0.6970634660498753 0.6970619903851056 6.10044909768459e-07 -0.09435857882831965 -1.165 0.6970664594442613 0.6970649700103224 6.075802425203891e-07 -0.09436024425962686 -1.1651000000000002 0.697069451942014 0.6970679487944225 6.049704437960379e-07 -0.09436190921353693 -1.1652 0.6970724435418449 0.697070926739177 6.022161358060218e-07 -0.09436357369017828 -1.1653 0.6970754342424721 0.6970739038463505 5.99317973151714e-07 -0.09436523768967928 -1.1654 0.6970784240426211 0.6970768801177003 5.962766424227883e-07 -0.0943669012121683 -1.1655 0.6970814129410248 0.6970798555549758 5.930928622249754e-07 -0.09436856425777365 -1.1656000000000002 0.6970844009364243 0.6970828301599186 5.897673828608729e-07 -0.09437022682662366 -1.1657 0.6970873880275689 0.6970858039342616 5.863009862883128e-07 -0.09437188891884662 -1.1658 0.6970903742132164 0.6970887768797294 5.826944858566829e-07 -0.09437355053457075 -1.1659000000000002 0.6970933594921335 0.6970917489980375 5.789487261265158e-07 -0.09437521167392435 -1.166 0.6970963438630957 0.6970947202908915 5.750645827445888e-07 -0.09437687233703547 -1.1661000000000001 0.6970993273248887 0.6970976907599884 5.710429620275903e-07 -0.09437853252403235 -1.1662000000000001 0.697102309876308 0.6971006604070142 5.668848011008976e-07 -0.09438019223504317 -1.1663 0.6971052915161589 0.6971036292336452 5.625910673434653e-07 -0.09438185147019595 -1.1664 0.6971082722432573 0.6971065972415468 5.581627584433368e-07 -0.0943835102296188 -1.1665 0.6971112520564302 0.6971095644323735 5.536009018702881e-07 -0.09438516851343975 -1.1666 0.697114230954516 0.6971125308077682 5.489065549035832e-07 -0.09438682632178683 -1.1667 0.6971172089363635 0.6971154963693629 5.440808042433964e-07 -0.09438848365478797 -1.1668 0.6971201860008345 0.6971184611187772 5.391247657748899e-07 -0.09439014051257118 -1.1669 0.6971231621468019 0.6971214250576185 5.340395843739243e-07 -0.09439179689526436 -1.167 0.697126137373152 0.6971243881874823 5.288264336295034e-07 -0.09439345280299545 -1.1671 0.6971291116787828 0.6971273505099503 5.23486515455196e-07 -0.09439510823589226 -1.1672 0.6971320850626059 0.6971303120265919 5.180210599503576e-07 -0.09439676319408265 -1.1673 0.6971350575235458 0.6971332727389628 5.124313250670642e-07 -0.09439841767769443 -1.1674 0.6971380290605405 0.6971362326486046 5.067185963880672e-07 -0.09440007168685527 -1.1675 0.6971409996725424 0.6971391917570462 5.008841866549485e-07 -0.09440172522169311 -1.1676000000000002 0.6971439693585177 0.697142150065801 4.949294356015876e-07 -0.09440337828233557 -1.1677 0.6971469381174471 0.6971451075763682 4.888557097459945e-07 -0.09440503086891029 -1.1678 0.6971499059483257 0.697148064290232 4.826644018629533e-07 -0.09440668298154498 -1.1679000000000002 0.6971528728501641 0.6971510202088622 4.763569306787119e-07 -0.0944083346203673 -1.168 0.6971558388219878 0.6971539753337124 4.699347408432253e-07 -0.09440998578550476 -1.1681000000000001 0.6971588038628378 0.6971569296662212 4.6339930218075587e-07 -0.094411636477085 -1.1682000000000001 0.6971617679717712 0.697159883207811 4.567521096759952e-07 -0.09441328669523558 -1.1683 0.6971647311478606 0.6971628359598877 4.499946830646695e-07 -0.09441493644008392 -1.1684 0.6971676933901957 0.6971657879238415 4.4312856622291674e-07 -0.0944165857117576 -1.1685 0.697170654697882 0.6971687391010454 4.3615532720892025e-07 -0.094418234510384 -1.1686 0.6971736150700422 0.6971716894928557 4.290765576869804e-07 -0.0944198828360906 -1.1687 0.6971765745058158 0.6971746391006113 4.218938725458754e-07 -0.09442153068900475 -1.1688 0.6971795330043601 0.6971775879256337 4.146089097045724e-07 -0.0944231780692538 -1.1689 0.6971824905648494 0.6971805359692269 4.07223329487727e-07 -0.09442482497696512 -1.169 0.6971854471864762 0.6971834832326773 3.9973881452159965e-07 -0.09442647141226605 -1.1691 0.6971884028684503 0.6971864297172528 3.921570690956777e-07 -0.09442811737528381 -1.1692 0.6971913576100006 0.6971893754242027 3.8447981896144734e-07 -0.09442976286614563 -1.1693 0.697194311410374 0.6971923203547582 3.767088108189154e-07 -0.09443140788497878 -1.1694 0.6971972642688362 0.6971952645101314 3.6884581203211475e-07 -0.09443305243191043 -1.1695 0.6972002161846715 0.6971982078915158 3.6089261009480955e-07 -0.09443469650706775 -1.1696000000000002 0.6972031671571837 0.697201150500085 3.5285101238069494e-07 -0.09443634011057779 -1.1697 0.6972061171856958 0.6972040923369939 3.447228455813467e-07 -0.09443798324256776 -1.1698 0.6972090662695499 0.6972070334033773 3.365099553731543e-07 -0.09443962590316467 -1.1699000000000002 0.6972120144081084 0.6972099737003505 3.2821420602874296e-07 -0.09444126809249556 -1.17 0.6972149616007532 0.6972129132290085 3.19837479924312e-07 -0.09444290981068747 -1.1701000000000001 0.6972179078468863 0.6972158519904262 3.1138167709554576e-07 -0.0944445510578673 -1.1702000000000001 0.6972208531459302 0.6972187899856584 3.0284871493230225e-07 -0.09444619183416209 -1.1703 0.6972237974973274 0.697221727215739 2.9424052758880714e-07 -0.0944478321396987 -1.1704 0.6972267409005416 0.6972246636816813 2.8555906566446465e-07 -0.09444947197460411 -1.1705 0.6972296833550569 0.6972275993844779 2.768062956903794e-07 -0.09445111133900515 -1.1706 0.6972326248603782 0.6972305343250997 2.6798419975465615e-07 -0.09445275023302861 -1.1707 0.6972355654160319 0.6972334685044972 2.5909477495422717e-07 -0.09445438865680135 -1.1708 0.6972385050215654 0.6972364019235988 2.501400330132131e-07 -0.09445602661045009 -1.1709 0.6972414436765475 0.6972393345833119 2.411219998874059e-07 -0.09445766409410161 -1.171 0.6972443813805687 0.697242266484522 2.3204271515364638e-07 -0.09445930110788264 -1.1711 0.6972473181332411 0.6972451976280927 2.2290423161430706e-07 -0.09446093765191983 -1.1712 0.6972502539341987 0.697248128014866 2.1370861486708082e-07 -0.09446257372633989 -1.1713 0.6972531887830973 0.6972510576456614 2.0445794288170838e-07 -0.09446420933126938 -1.1714 0.6972561226796152 0.6972539865212763 1.9515430542058065e-07 -0.09446584446683501 -1.1715 0.6972590556234524 0.697256914642486 1.8579980360158843e-07 -0.09446747913316322 -1.1716000000000002 0.6972619876143313 0.6972598420100431 1.7639654943321648e-07 -0.09446911333038065 -1.1717 0.6972649186519968 0.6972627686246777 1.6694666536351543e-07 -0.0944707470586137 -1.1718 0.6972678487362167 0.6972656944870979 1.5745228377009313e-07 -0.094472380317989 -1.1719000000000002 0.6972707778667809 0.6972686195979876 1.4791554648826977e-07 -0.0944740131086329 -1.172 0.6972737060435021 0.697271543958009 1.3833860432535539e-07 -0.09447564543067184 -1.1721000000000001 0.6972766332662164 0.6972744675678015 1.287236165922745e-07 -0.09447727728423222 -1.1722000000000001 0.697279559534782 0.6972773904279806 1.1907275058661848e-07 -0.09447890866944043 -1.1723 0.6972824848490805 0.6972803125391394 1.0938818113467863e-07 -0.09448053958642279 -1.1724 0.6972854092090168 0.6972832339018474 9.967209006755962e-08 -0.09448217003530564 -1.1725 0.6972883326145184 0.6972861545166512 8.992666576321251e-08 -0.0944838000162152 -1.1726 0.6972912550655362 0.6972890743840736 8.015410263642608e-08 -0.09448542952927776 -1.1727 0.6972941765620445 0.6972919935046145 7.03566006583084e-08 -0.09448705857461946 -1.1728 0.6972970971040408 0.6972949118787503 6.053636484454339e-08 -0.09448868715236661 -1.1729 0.6973000166915456 0.6972978295069335 5.069560476619883e-08 -0.09449031526264524 -1.173 0.6973029353246036 0.6973007463895939 4.083653404839127e-08 -0.0944919429055816 -1.1731 0.6973058530032823 0.6973036625271369 3.096136988456344e-08 -0.09449357008130171 -1.1732 0.6973087697276728 0.6973065779199449 2.1072332526475557e-08 -0.09449519678993168 -1.1733 0.6973116854978896 0.6973094925683764 1.1171644795013314e-08 -0.09449682303159751 -1.1734 0.6973146003140709 0.6973124064727665 1.2615315658423554e-09 -0.09449844880642527 -1.1735 0.6973175141763784 0.6973153196334262 -8.65578071284484e-09 -0.09450007411454092 -1.1736000000000002 0.6973204270849976 0.6973182320506436 -1.8578064533373434e-08 -0.09450169895607047 -1.1737 0.697323339040137 0.697321143724682 -2.8503091823849774e-08 -0.09450332333113975 -1.1738 0.697326250042029 0.6973240546557824 -3.842863445079753e-08 -0.09450494723987474 -1.1739000000000002 0.697329160090929 0.6973269648441613 -4.8352464714936224e-08 -0.09450657068240127 -1.174 0.6973320691871168 0.6973298742900116 -5.8272355855579216e-08 -0.09450819365884516 -1.1741000000000001 0.6973349773308952 0.6973327829935023 -6.81860825462767e-08 -0.09450981616933223 -1.1742000000000001 0.6973378845225907 0.6973356909547797 -7.809142139880709e-08 -0.0945114382139883 -1.1743 0.6973407907625531 0.6973385981739655 -8.798615145841349e-08 -0.09451305979293906 -1.1744 0.6973436960511554 0.6973415046511586 -9.786805470375637e-08 -0.09451468090631027 -1.1745 0.6973466003887947 0.6973444103864341 -1.0773491653133516e-07 -0.09451630155422758 -1.1746 0.6973495037758909 0.6973473153798435 -1.17584526278941e-07 -0.09451792173681672 -1.1747 0.6973524062128875 0.697350219631415 -1.2741467770097104e-07 -0.0945195414542033 -1.1747999999999998 0.697355307700251 0.6973531231411532 -1.3722316946282453e-07 -0.0945211607065129 -1.1749 0.6973582082384713 0.6973560259090397 -1.4700780563529914e-07 -0.09452277949387111 -1.175 0.6973611078280615 0.6973589279350327 -1.567663962011301e-07 -0.09452439781640348 -1.1751 0.6973640064695574 0.6973618292190671 -1.6649675752163084e-07 -0.09452601567423552 -1.1752 0.6973669041635184 0.697364729761055 -1.7619671283455873e-07 -0.09452763306749273 -1.1753 0.6973698009105261 0.697367629560885 -1.8586409275545002e-07 -0.09452924999630055 -1.1754 0.6973726967111857 0.6973705286184233 -1.9549673574079107e-07 -0.09453086646078444 -1.1755 0.6973755915661244 0.6973734269335126 -2.0509248858241458e-07 -0.09453248246106977 -1.1756000000000002 0.6973784854759929 0.6973763245059732 -2.146492069018957e-07 -0.09453409799728192 -1.1757 0.6973813784414635 0.6973792213356027 -2.2416475557382465e-07 -0.09453571306954624 -1.1758 0.6973842704632317 0.6973821174221763 -2.336370093017348e-07 -0.094537327677988 -1.1759000000000002 0.6973871615420151 0.6973850127654462 -2.430638529858642e-07 -0.09453894182273256 -1.176 0.6973900516785536 0.6973879073651428 -2.5244318228173634e-07 -0.09454055550390514 -1.1761000000000001 0.697392940873609 0.6973908012209737 -2.6177290402690234e-07 -0.09454216872163095 -1.1762000000000001 0.6973958291279654 0.6973936943326251 -2.7105093668503e-07 -0.0945437814760352 -1.1763 0.6973987164424285 0.6973965866997606 -2.802752108732598e-07 -0.09454539376724304 -1.1764000000000001 0.6974016028178256 0.6973994783220223 -2.8944366976466074e-07 -0.09454700559537961 -1.1765 0.6974044882550063 0.6974023691990303 -2.9855426962599463e-07 -0.09454861696057004 -1.1766 0.6974073727548408 0.6974052593303838 -3.0760498014037463e-07 -0.09455022786293941 -1.1767 0.6974102563182211 0.6974081487156596 -3.165937850144185e-07 -0.09455183830261275 -1.1767999999999998 0.6974131389460602 0.6974110373544139 -3.2551868231478487e-07 -0.09455344827971508 -1.1769 0.6974160206392921 0.6974139252461816 -3.3437768492960984e-07 -0.09455505779437141 -1.177 0.6974189013988717 0.6974168123904769 -3.4316882110280167e-07 -0.09455666684670674 -1.1771 0.6974217812257746 0.6974196987867928 -3.5189013476710773e-07 -0.09455827543684592 -1.1772 0.6974246601209962 0.6974225844346018 -3.6053968600208153e-07 -0.09455988356491389 -1.1773 0.6974275380855535 0.6974254693333566 -3.691155514781719e-07 -0.09456149123103556 -1.1774 0.6974304151204824 0.6974283534824884 -3.776158249216288e-07 -0.09456309843533574 -1.1775 0.6974332912268396 0.6974312368814095 -3.8603861751002055e-07 -0.09456470517793925 -1.1776000000000002 0.6974361664057012 0.697434119529512 -3.9438205820530037e-07 -0.09456631145897088 -1.1777 0.6974390406581628 0.6974370014261676 -4.026442943505515e-07 -0.0945679172785554 -1.1778 0.6974419139853395 0.6974398825707295 -4.108234919336651e-07 -0.09456952263681756 -1.1779000000000002 0.6974447863883654 0.697442762962531 -4.189178360244905e-07 -0.09457112753388199 -1.178 0.6974476578683937 0.697445642600887 -4.269255312258635e-07 -0.09457273196987341 -1.1781000000000001 0.6974505284265966 0.6974485214850927 -4.3484480203442866e-07 -0.09457433594491646 -1.1782000000000001 0.6974533980641644 0.6974513996144251 -4.4267389322921735e-07 -0.09457593945913575 -1.1783 0.6974562667823059 0.6974542769881429 -4.5041107028104266e-07 -0.09457754251265589 -1.1784000000000001 0.6974591345822478 0.6974571536054861 -4.580546197549551e-07 -0.09457914510560142 -1.1785 0.6974620014652348 0.6974600294656772 -4.656028496086151e-07 -0.09458074723809679 -1.1786 0.6974648674325297 0.6974629045679207 -4.7305408967801554e-07 -0.09458234891026664 -1.1787 0.6974677324854119 0.6974657789114036 -4.804066919619765e-07 -0.09458395012223532 -1.1787999999999998 0.6974705966251784 0.697468652495296 -4.876590310107232e-07 -0.09458555087412736 -1.1789 0.6974734598531429 0.6974715253187507 -4.948095043283418e-07 -0.09458715116606717 -1.179 0.697476322170636 0.697474397380903 -5.018565326642133e-07 -0.09458875099817902 -1.1791 0.6974791835790046 0.697477268680873 -5.087985603738354e-07 -0.09459035037058738 -1.1792 0.6974820440796117 0.6974801392177636 -5.156340558212791e-07 -0.09459194928341652 -1.1793 0.6974849036738361 0.6974830089906621 -5.223615116289881e-07 -0.09459354773679073 -1.1794 0.6974877623630727 0.6974858779986395 -5.289794450524798e-07 -0.09459514573083429 -1.1795 0.6974906201487314 0.697488746240752 -5.354863983342284e-07 -0.09459674326567145 -1.1796000000000002 0.6974934770322372 0.6974916137160403 -5.418809389950985e-07 -0.09459834034142636 -1.1797 0.6974963330150301 0.6974944804235299 -5.481616601882289e-07 -0.09459993695822326 -1.1798 0.6974991880985646 0.6974973463622318 -5.543271808794437e-07 -0.09460153311618628 -1.1799000000000002 0.6975020422843095 0.6975002115311428 -5.603761463607304e-07 -0.09460312881543956 -1.18 0.6975048955737474 0.6975030759292454 -5.663072283473847e-07 -0.09460472405610715 -1.1801000000000001 0.6975077479683748 0.6975059395555081 -5.721191253943436e-07 -0.09460631883831311 -1.1802000000000001 0.697510599469702 0.697508802408886 -5.778105631459862e-07 -0.0946079131621815 -1.1803 0.6975134500792517 0.6975116644883212 -5.833802946275668e-07 -0.09460950702783633 -1.1804000000000001 0.69751629979856 0.6975145257927424 -5.888271004672596e-07 -0.09461110043540158 -1.1805 0.6975191486291756 0.6975173863210656 -5.941497892708592e-07 -0.09461269338500118 -1.1806 0.6975219965726589 0.697520246072195 -5.993471977050469e-07 -0.09461428587675906 -1.1807 0.6975248436305825 0.6975231050450224 -6.044181909276025e-07 -0.09461587791079909 -1.1807999999999998 0.6975276898045315 0.6975259632384274 -6.093616628233267e-07 -0.0946174694872452 -1.1809 0.6975305350961007 0.6975288206512787 -6.141765360734297e-07 -0.09461906060622109 -1.181 0.6975333795068972 0.6975316772824338 -6.188617625579873e-07 -0.09462065126785064 -1.1811 0.6975362230385382 0.6975345331307391 -6.234163235502299e-07 -0.0946222414722576 -1.1812 0.6975390656926519 0.6975373881950306 -6.278392299247093e-07 -0.09462383121956572 -1.1813 0.6975419074708761 0.6975402424741342 -6.321295223515877e-07 -0.09462542050989875 -1.1814 0.6975447483748587 0.6975430959668658 -6.362862715048045e-07 -0.09462700934338035 -1.1815 0.6975475884062565 0.6975459486720315 -6.403085783257545e-07 -0.09462859772013414 -1.1816000000000002 0.6975504275667364 0.6975488005884285 -6.441955741204319e-07 -0.0946301856402838 -1.1817 0.6975532658579728 0.6975516517148452 -6.479464208924979e-07 -0.09463177310395292 -1.1818 0.69755610328165 0.6975545020500613 -6.515603113294022e-07 -0.0946333601112651 -1.1819000000000002 0.6975589398394594 0.6975573515928476 -6.550364691076949e-07 -0.09463494666234383 -1.182 0.6975617755331007 0.6975602003419675 -6.583741490734374e-07 -0.09463653275731262 -1.1821000000000002 0.6975646103642809 0.6975630482961768 -6.615726373115915e-07 -0.09463811839629498 -1.1822000000000001 0.6975674443347142 0.6975658954542241 -6.646312513819419e-07 -0.09463970357941433 -1.1823 0.6975702774461219 0.6975687418148508 -6.675493403884847e-07 -0.09464128830679416 -1.1824000000000001 0.697573109700231 0.6975715873767918 -6.703262852014724e-07 -0.09464287257855777 -1.1825 0.6975759410987757 0.6975744321387757 -6.729614984990473e-07 -0.09464445639482859 -1.1826 0.6975787716434956 0.6975772760995254 -6.754544250447969e-07 -0.09464603975572997 -1.1827 0.6975816013361353 0.6975801192577579 -6.77804541576732e-07 -0.09464762266138521 -1.1827999999999999 0.6975844301784453 0.6975829616121851 -6.800113571125976e-07 -0.0946492051119176 -1.1829 0.6975872581721803 0.6975858031615139 -6.820744129082401e-07 -0.09465078710745035 -1.183 0.6975900853190996 0.6975886439044469 -6.839932826935291e-07 -0.09465236864810674 -1.1831 0.6975929116209667 0.697591483839682 -6.857675726862356e-07 -0.0946539497340099 -1.1832 0.6975957370795487 0.697594322965914 -6.873969216752984e-07 -0.09465553036528304 -1.1833 0.6975985616966165 0.6975971612818334 -6.888810010208246e-07 -0.09465711054204934 -1.1834 0.6976013854739435 0.6975999987861277 -6.902195149038892e-07 -0.09465869026443181 -1.1835 0.697604208413306 0.6976028354774817 -6.914122002016354e-07 -0.09466026953255353 -1.1836000000000002 0.6976070305164831 0.697605671354578 -6.924588266260523e-07 -0.09466184834653768 -1.1837 0.6976098517852553 0.6976085064160966 -6.933591967656083e-07 -0.09466342670650715 -1.1838 0.6976126722214051 0.697611340660716 -6.941131461546401e-07 -0.09466500461258498 -1.1839000000000002 0.6976154918267162 0.697614174087113 -6.947205431762082e-07 -0.09466658206489413 -1.184 0.6976183106029735 0.6976170066939636 -6.951812892008746e-07 -0.09466815906355755 -1.1841000000000002 0.6976211285519621 0.6976198384799428 -6.954953186005808e-07 -0.09466973560869812 -1.1842000000000001 0.6976239456754679 0.6976226694437255 -6.956625987070142e-07 -0.09467131170043874 -1.1843 0.6976267619752761 0.6976254995839862 -6.956831297560973e-07 -0.09467288733890221 -1.1844000000000001 0.6976295774531722 0.6976283288994003 -6.955569450406429e-07 -0.09467446252421145 -1.1845 0.6976323921109402 0.6976311573886431 -6.952841107438212e-07 -0.09467603725648917 -1.1846 0.6976352059503637 0.6976339850503914 -6.948647260085483e-07 -0.09467761153585817 -1.1847 0.6976380189732241 0.6976368118833229 -6.942989228680974e-07 -0.09467918536244112 -1.1847999999999999 0.6976408311813014 0.6976396378861179 -6.935868662044653e-07 -0.09468075873636078 -1.1849 0.6976436425763733 0.697642463057458 -6.92728753734495e-07 -0.09468233165773983 -1.185 0.6976464531602153 0.6976452873960273 -6.917248158988532e-07 -0.0946839041267009 -1.1851 0.6976492629345995 0.6976481109005128 -6.90575315848152e-07 -0.0946854761433666 -1.1852 0.6976520719012951 0.6976509335696047 -6.892805494290721e-07 -0.09468704770785956 -1.1853 0.6976548800620674 0.6976537554019961 -6.878408449484397e-07 -0.09468861882030222 -1.1854 0.6976576874186788 0.6976565763963847 -6.862565632981266e-07 -0.09469018948081727 -1.1855 0.6976604939728865 0.6976593965514715 -6.845280976913726e-07 -0.09469175968952714 -1.1856000000000002 0.6976632997264431 0.6976622158659626 -6.826558736072741e-07 -0.09469332944655429 -1.1857 0.6976661046810966 0.6976650343385684 -6.80640348804662e-07 -0.09469489875202118 -1.1858 0.69766890883859 0.6976678519680051 -6.784820130861791e-07 -0.09469646760605024 -1.1859000000000002 0.6976717122006602 0.6976706687529937 -6.76181388187258e-07 -0.09469803600876381 -1.186 0.697674514769038 0.6976734846922616 -6.737390276512212e-07 -0.09469960396028432 -1.1861000000000002 0.6976773165454485 0.6976762997845418 -6.711555168431582e-07 -0.09470117146073403 -1.1862000000000001 0.6976801175316102 0.6976791140285744 -6.684314726307372e-07 -0.09470273851023531 -1.1863 0.6976829177292343 0.6976819274231059 -6.6556754328706e-07 -0.0947043051089104 -1.1864000000000001 0.6976857171400246 0.6976847399668897 -6.625644083518845e-07 -0.09470587125688151 -1.1865 0.6976885157656776 0.6976875516586877 -6.594227784789686e-07 -0.09470743695427092 -1.1866 0.6976913136078817 0.6976903624972687 -6.561433952417817e-07 -0.09470900220120076 -1.1867 0.6976941106683174 0.6976931724814097 -6.527270310086042e-07 -0.09471056699779323 -1.1867999999999999 0.6976969069486562 0.6976959816098969 -6.49174488789872e-07 -0.09471213134417046 -1.1869 0.6976997024505608 0.6976987898815243 -6.454866018495986e-07 -0.09471369524045453 -1.187 0.6977024971756847 0.6977015972950958 -6.41664233747008e-07 -0.0947152586867675 -1.1871 0.6977052911256718 0.6977044038494242 -6.37708278017346e-07 -0.09471682168323142 -1.1872 0.6977080843021564 0.6977072095433328 -6.336196580053466e-07 -0.09471838422996831 -1.1873 0.6977108767067621 0.6977100143756538 -6.293993266154319e-07 -0.09471994632710017 -1.1874 0.6977136683411027 0.6977128183452306 -6.250482661174228e-07 -0.09472150797474893 -1.1875 0.6977164592067804 0.6977156214509171 -6.205674878967393e-07 -0.09472306917303651 -1.1876000000000002 0.697719249305387 0.6977184236915785 -6.159580322323555e-07 -0.09472462992208486 -1.1877 0.6977220386385026 0.6977212250660906 -6.112209680747549e-07 -0.09472619022201578 -1.1878 0.6977248272076956 0.6977240255733412 -6.063573927961308e-07 -0.09472775007295117 -1.1879000000000002 0.6977276150145225 0.6977268252122301 -6.013684318573187e-07 -0.09472930947501285 -1.188 0.6977304020605273 0.6977296239816688 -5.962552386828968e-07 -0.09473086842832254 -1.1881000000000002 0.6977331883472416 0.697732421880582 -5.910189942448518e-07 -0.09473242693300205 -1.1882000000000001 0.6977359738761841 0.6977352189079065 -5.856609069376795e-07 -0.0947339849891731 -1.1883 0.6977387586488604 0.6977380150625925 -5.801822122036837e-07 -0.09473554259695738 -1.1884000000000001 0.6977415426667624 0.6977408103436036 -5.745841723248102e-07 -0.0947370997564766 -1.1885 0.6977443259313685 0.6977436047499166 -5.688680760063125e-07 -0.09473865646785236 -1.1886 0.6977471084441426 0.6977463982805227 -5.630352381824633e-07 -0.09474021273120628 -1.1887 0.6977498902065347 0.6977491909344267 -5.570869997112426e-07 -0.09474176854665987 -1.1887999999999999 0.6977526712199809 0.6977519827106482 -5.510247270967827e-07 -0.09474332391433478 -1.1889 0.6977554514859012 0.6977547736082219 -5.448498120314005e-07 -0.09474487883435252 -1.189 0.6977582310057016 0.6977575636261968 -5.385636712221253e-07 -0.09474643330683459 -1.1891 0.6977610097807718 0.6977603527636376 -5.321677460090601e-07 -0.09474798733190246 -1.1892 0.6977637878124867 0.6977631410196241 -5.256635020531308e-07 -0.09474954090967756 -1.1893 0.6977665651022049 0.6977659283932519 -5.190524289613863e-07 -0.09475109404028129 -1.1894 0.6977693416512688 0.6977687148836329 -5.123360399539312e-07 -0.09475264672383502 -1.1895 0.697772117461005 0.6977715004898951 -5.05515871621065e-07 -0.09475419896046015 -1.1896000000000002 0.697774892532723 0.697774285211183 -4.985934834722539e-07 -0.09475575075027802 -1.1897 0.6977776668677155 0.6977770690466579 -4.915704575128577e-07 -0.09475730209340988 -1.1898 0.6977804404672583 0.6977798519954976 -4.844483980567804e-07 -0.09475885298997701 -1.1899000000000002 0.6977832133326097 0.6977826340568978 -4.772289312476863e-07 -0.09476040344010069 -1.19 0.6977859854650108 0.6977854152300711 -4.6991370472593275e-07 -0.09476195344390209 -1.1901000000000002 0.6977887568656842 0.6977881955142478 -4.625043871636647e-07 -0.09476350300150237 -1.1902000000000001 0.6977915275358357 0.6977909749086763 -4.550026680566477e-07 -0.09476505211302276 -1.1903 0.6977942974766518 0.6977937534126231 -4.4741025720385075e-07 -0.09476660077858433 -1.1904000000000001 0.6977970666893012 0.6977965310253724 -4.3972888434662405e-07 -0.09476814899830815 -1.1905 0.6977998351749337 0.6977993077462279 -4.3196029881481524e-07 -0.09476969677231539 -1.1906 0.6978026029346804 0.6978020835745113 -4.24106269096558e-07 -0.09477124410072706 -1.1907 0.6978053699696534 0.6978048585095633 -4.1616858243581634e-07 -0.09477279098366406 -1.1907999999999999 0.6978081362809454 0.6978076325507436 -4.081490444160507e-07 -0.09477433742124747 -1.1909 0.6978109018696304 0.6978104056974316 -4.000494785438846e-07 -0.09477588341359831 -1.191 0.6978136667367616 0.6978131779490255 -3.918717259090987e-07 -0.09477742896083735 -1.1911 0.6978164308833735 0.6978159493049441 -3.8361764469196924e-07 -0.09477897406308561 -1.1912 0.6978191943104802 0.697818719764625 -3.7528910974693463e-07 -0.09478051872046389 -1.1913 0.6978219570190758 0.6978214893275265 -3.66888012227895e-07 -0.09478206293309305 -1.1914 0.6978247190101339 0.6978242579931268 -3.5841625908167307e-07 -0.09478360670109391 -1.1915 0.6978274802846081 0.6978270257609247 -3.498757727010693e-07 -0.09478515002458729 -1.1916000000000002 0.6978302408434308 0.697829792630439 -3.4126849039056717e-07 -0.09478669290369386 -1.1917 0.6978330006875142 0.6978325586012097 -3.325963640263274e-07 -0.09478823533853445 -1.1918 0.6978357598177493 0.6978353236727968 -3.2386135956352646e-07 -0.09478977732922966 -1.1919000000000002 0.697838518235006 0.6978380878447824 -3.150654565714506e-07 -0.09479131887590023 -1.192 0.6978412759401331 0.6978408511167686 -3.062106478379789e-07 -0.09479285997866672 -1.1921000000000002 0.6978440329339584 0.6978436134883794 -2.9729893889079984e-07 -0.09479440063764985 -1.1922000000000001 0.6978467892172875 0.6978463749592598 -2.8833234753250503e-07 -0.09479594085297016 -1.1923 0.697849544790905 0.6978491355290765 -2.793129033895614e-07 -0.0947974806247482 -1.1924000000000001 0.6978522996555734 0.6978518951975174 -2.7024264747863014e-07 -0.09479901995310447 -1.1925 0.6978550538120336 0.6978546539642925 -2.6112363171737485e-07 -0.09480055883815947 -1.1926 0.6978578072610051 0.6978574118291332 -2.5195791846302495e-07 -0.09480209728003369 -1.1927 0.6978605600031844 0.6978601687917934 -2.4274758006828656e-07 -0.09480363527884758 -1.1927999999999999 0.6978633120392463 0.6978629248520487 -2.3349469837827264e-07 -0.09480517283472156 -1.1929 0.6978660633698439 0.697865680009697 -2.24201364272536e-07 -0.09480670994777604 -1.193 0.6978688139956069 0.6978684342645578 -2.1486967723485795e-07 -0.09480824661813131 -1.1931 0.697871563917143 0.6978711876164736 -2.055017448154839e-07 -0.09480978284590771 -1.1932 0.6978743131350379 0.6978739400653088 -1.9609968216968698e-07 -0.09481131863122555 -1.1933 0.6978770616498543 0.6978766916109507 -1.8666561163796502e-07 -0.09481285397420512 -1.1934 0.6978798094621324 0.6978794422533086 -1.7720166219092892e-07 -0.09481438887496661 -1.1935 0.6978825565723896 0.697882191992315 -1.677099689852135e-07 -0.0948159233336303 -1.1936000000000002 0.6978853029811206 0.6978849408279247 -1.581926728812244e-07 -0.09481745735031638 -1.1937 0.6978880486887971 0.697887688760115 -1.4865191995741545e-07 -0.09481899092514491 -1.1938 0.6978907936958686 0.6978904357888862 -1.3908986103323973e-07 -0.09482052405823611 -1.1939000000000002 0.6978935380027609 0.6978931819142613 -1.2950865116781451e-07 -0.0948220567497101 -1.194 0.697896281609877 0.6978959271362863 -1.1991044918113758e-07 -0.09482358899968688 -1.1941000000000002 0.6978990245175974 0.6978986714550302 -1.1029741718397712e-07 -0.09482512080828653 -1.1942000000000002 0.697901766726279 0.6979014148705842 -1.0067172006786307e-07 -0.09482665217562904 -1.1943 0.6979045082362559 0.6979041573830631 -9.10355250289055e-08 -0.09482818310183443 -1.1944000000000001 0.6979072490478394 0.6979068989926045 -8.139100108120467e-08 -0.09482971358702263 -1.1945 0.6979099891613172 0.6979096396993687 -7.174031856765906e-08 -0.09483124363131357 -1.1946 0.6979127285769543 0.6979123795035395 -6.208564866556909e-08 -0.09483277323482718 -1.1947 0.6979154672949925 0.6979151184053229 -5.242916290741986e-08 -0.09483430239768331 -1.1947999999999999 0.6979182053156506 0.6979178564049486 -4.2773032685834364e-08 -0.09483583112000177 -1.1949 0.6979209426391242 0.6979205935026689 -3.311942876839304e-08 -0.09483735940190245 -1.195 0.6979236792655861 0.697923329698759 -2.3470520809417555e-08 -0.09483888724350512 -1.1951 0.6979264151951854 0.6979260649935172 -1.3828476860561906e-08 -0.09484041464492948 -1.1952 0.6979291504280491 0.6979287993872645 -4.195462885957235e-09 -0.09484194160629533 -1.1953 0.6979318849642804 0.6979315328803453 5.4263577242696925e-09 -0.09484346812772232 -1.1954 0.6979346188039601 0.697934265473126 1.5034824639610644e-08 -0.09484499420933017 -1.1955 0.6979373519471455 0.6979369971659966 2.4627781080970024e-08 -0.09484651985123846 -1.1956000000000002 0.6979400843938717 0.6979397279593695 3.420307428947389e-08 -0.09484804505356687 -1.1957 0.6979428161441505 0.6979424578536799 4.37585560286724e-08 -0.094849569816435 -1.1958 0.6979455471979712 0.6979451868493857 5.329208304684363e-08 -0.09485109413996239 -1.1959000000000002 0.6979482775553 0.6979479149469672 6.280151757832864e-08 -0.09485261802426853 -1.196 0.6979510072160808 0.6979506421469275 7.228472780583528e-08 -0.094854141469473 -1.1961000000000002 0.6979537361802348 0.697953368449792 8.173958834269135e-08 -0.09485566447569523 -1.1962000000000002 0.6979564644476604 0.6979560938561087 9.116398071509768e-08 -0.09485718704305464 -1.1963 0.697959192018234 0.6979588183664478 1.0055579384091184e-07 -0.09485870917167072 -1.1964000000000001 0.6979619188918091 0.6979615419814016 1.099129244702679e-07 -0.09486023086166279 -1.1965 0.697964645068218 0.697964264701585 1.1923327771293235e-07 -0.09486175211315027 -1.1966 0.6979673705472693 0.6979669865276343 1.2851476745290302e-07 -0.09486327292625242 -1.1967 0.697970095328751 0.6979697074602085 1.3775531683066222e-07 -0.09486479330108864 -1.1967999999999999 0.6979728194124282 0.6979724274999879 1.4695285875318542e-07 -0.09486631323777817 -1.1969 0.6979755427980442 0.6979751466476748 1.561053362651721e-07 -0.09486783273644027 -1.197 0.697978265485321 0.6979778649039929 1.652107031110961e-07 -0.09486935179719413 -1.1971 0.6979809874739589 0.6979805822696881 1.742669241272532e-07 -0.09487087042015896 -1.1972 0.6979837087636358 0.6979832987455263 1.832719756927892e-07 -0.0948723886054539 -1.1973 0.6979864293540095 0.6979860143322965 1.9222384622930022e-07 -0.09487390635319812 -1.1974 0.6979891492447158 0.6979887290308073 2.0112053660328866e-07 -0.0948754236635107 -1.1975 0.6979918684353696 0.6979914428418893 2.099600606084162e-07 -0.09487694053651079 -1.1976000000000002 0.6979945869255645 0.6979941557663931 2.1874044540959314e-07 -0.09487845697231728 -1.1977 0.6979973047148739 0.6979968678051911 2.2745973190380075e-07 -0.09487997297104937 -1.1978 0.6980000218028501 0.6979995789591751 2.3611597529255013e-07 -0.09488148853282602 -1.1979000000000002 0.6980027381890248 0.6980022892292581 2.447072454045407e-07 -0.09488300365776609 -1.198 0.6980054538729099 0.698004998616373 2.5323162716056613e-07 -0.09488451834598863 -1.1981000000000002 0.6980081688539963 0.698007707121473 2.6168722103842024e-07 -0.09488603259761251 -1.1982000000000002 0.6980108831317553 0.6980104147455306 2.700721434475972e-07 -0.09488754641275658 -1.1983 0.6980135967056385 0.6980131214895391 2.78384527166442e-07 -0.09488905979153972 -1.1984000000000001 0.6980163095750778 0.6980158273545105 2.8662252172378944e-07 -0.0948905727340808 -1.1985 0.698019021739485 0.6980185323414765 2.947842939055034e-07 -0.09489208524049854 -1.1986 0.6980217331982536 0.698021236451488 3.028680280459106e-07 -0.09489359731091175 -1.1987 0.6980244439507572 0.6980239396856147 3.108719265135229e-07 -0.09489510894543922 -1.1987999999999999 0.6980271539963505 0.6980266420449452 3.187942100996155e-07 -0.09489662014419957 -1.1989 0.6980298633343703 0.6980293435305869 3.2663311834435493e-07 -0.09489813090731153 -1.199 0.698032571964134 0.6980320441436654 3.3438691002946053e-07 -0.09489964123489375 -1.1991 0.698035279884941 0.6980347438853242 3.420538635112713e-07 -0.09490115112706482 -1.1992 0.6980379870960726 0.6980374427567257 3.496322771093241e-07 -0.09490266058394344 -1.1993 0.6980406935967921 0.6980401407590491 3.571204694671759e-07 -0.09490416960564807 -1.1994 0.6980433993863455 0.6980428378934918 3.6451677996179876e-07 -0.09490567819229734 -1.1995 0.6980461044639614 0.6980455341612678 3.718195690297077e-07 -0.0949071863440097 -1.1996000000000002 0.6980488088288505 0.698048229563609 3.790272186179888e-07 -0.09490869406090369 -1.1997 0.6980515124802069 0.6980509241017636 3.861381323716495e-07 -0.0949102013430977 -1.1998 0.6980542154172082 0.6980536177769969 3.9315073618872987e-07 -0.09491170819071022 -1.1999000000000002 0.6980569176390155 0.6980563105905899 4.0006347843540846e-07 -0.09491321460385962 -1.2 0.6980596191447732 0.6980590025438406 4.068748303415193e-07 -0.09491472058266431 -1.2001000000000002 0.69806231993361 0.6980616936380621 4.135832863405575e-07 -0.09491622612724263 -1.2002000000000002 0.6980650200046389 0.6980643838745837 4.201873643125409e-07 -0.09491773123771284 -1.2003 0.6980677193569573 0.6980670732547496 4.2668560608360995e-07 -0.09491923591419328 -1.2004000000000001 0.6980704179896473 0.6980697617799199 4.3307657760643936e-07 -0.09492074015680221 -1.2005 0.6980731159017761 0.6980724494514687 4.3935886933493817e-07 -0.09492224396565786 -1.2006000000000001 0.6980758130923959 0.6980751362707853 4.4553109652262224e-07 -0.0949237473408784 -1.2007 0.6980785095605446 0.6980778222392732 4.515918994862922e-07 -0.09492525028258204 -1.2007999999999999 0.6980812053052463 0.6980805073583499 4.57539944029306e-07 -0.09492675279088693 -1.2009 0.6980839003255106 0.698083191629447 4.633739216081123e-07 -0.09492825486591121 -1.201 0.6980865946203341 0.6980858750540092 4.690925495959286e-07 -0.09492975650777297 -1.2011 0.6980892881886986 0.6980885576334948 4.746945717892803e-07 -0.0949312577165902 -1.2012 0.6980919810295749 0.6980912393693748 4.801787584357564e-07 -0.09493275849248102 -1.2013 0.6980946731419193 0.6980939202631329 4.855439066364653e-07 -0.09493425883556338 -1.2014 0.6980973645246765 0.6980966003162656 4.907888404709349e-07 -0.09493575874595529 -1.2015 0.6981000551767786 0.6980992795302813 4.959124115105906e-07 -0.09493725822377472 -1.2016000000000002 0.6981027450971459 0.6981019579066997 5.00913498804878e-07 -0.09493875726913954 -1.2017 0.6981054342846871 0.6981046354470529 5.057910092559625e-07 -0.09494025588216773 -1.2018 0.6981081227382994 0.6981073121528836 5.105438779240412e-07 -0.09494175406297706 -1.2019000000000002 0.6981108104568692 0.6981099880257458 5.151710679995869e-07 -0.09494325181168546 -1.202 0.6981134974392716 0.6981126630672037 5.196715713862154e-07 -0.0949447491284107 -1.2021000000000002 0.6981161836843721 0.6981153372788322 5.240444086451745e-07 -0.09494624601327056 -1.2022 0.6981188691910256 0.698118010662216 5.282886293561662e-07 -0.09494774246638277 -1.2023 0.6981215539580773 0.6981206832189496 5.324033122144911e-07 -0.09494923848786509 -1.2024000000000001 0.6981242379843626 0.6981233549506367 5.363875653086048e-07 -0.09495073407783518 -1.2025 0.6981269212687085 0.6981260258588905 5.402405262866505e-07 -0.09495222923641079 -1.2026000000000001 0.6981296038099319 0.6981286959453326 5.439613626201378e-07 -0.09495372396370949 -1.2027 0.6981322856068425 0.6981313652115928 5.475492716178199e-07 -0.09495521825984893 -1.2027999999999999 0.6981349666582407 0.6981340336593099 5.510034807587605e-07 -0.09495671212494669 -1.2029 0.6981376469629197 0.6981367012901298 5.543232477478455e-07 -0.09495820555912038 -1.203 0.6981403265196646 0.698139368105706 5.575078607517048e-07 -0.09495969856248745 -1.2031 0.6981430053272534 0.6981420341076989 5.605566385236127e-07 -0.09496119113516543 -1.2032 0.6981456833844574 0.6981446992977762 5.634689305145102e-07 -0.09496268327727181 -1.2033 0.6981483606900409 0.698147363677612 5.66244117053416e-07 -0.09496417498892398 -1.2034 0.6981510372427624 0.6981500272488863 5.688816095139604e-07 -0.09496566627023946 -1.2035 0.6981537130413739 0.6981526900132852 5.71380850356018e-07 -0.09496715712133552 -1.2036000000000002 0.6981563880846221 0.6981553519725004 5.737413133199976e-07 -0.09496864754232964 -1.2037 0.6981590623712484 0.6981580131282283 5.759625034823523e-07 -0.0949701375333391 -1.2038 0.6981617358999893 0.6981606734821706 5.780439573527252e-07 -0.0949716270944812 -1.2039000000000002 0.6981644086695762 0.6981633330360332 5.799852429849706e-07 -0.09497311622587318 -1.204 0.698167080678737 0.6981659917915263 5.817859601298103e-07 -0.09497460492763232 -1.2041000000000002 0.6981697519261949 0.6981686497503641 5.834457402209559e-07 -0.09497609319987585 -1.2042 0.6981724224106702 0.6981713069142642 5.84964246583275e-07 -0.09497758104272098 -1.2043 0.6981750921308794 0.6981739632849475 5.863411742940139e-07 -0.09497906845628491 -1.2044000000000001 0.6981777610855362 0.6981766188641371 5.87576250474231e-07 -0.09498055544068473 -1.2045 0.698180429273352 0.6981792736535593 5.886692340806299e-07 -0.09498204199603755 -1.2046000000000001 0.6981830966930351 0.6981819276549421 5.89619916252504e-07 -0.09498352812246043 -1.2047 0.6981857633432931 0.6981845808700158 5.904281200619366e-07 -0.09498501382007052 -1.2047999999999999 0.6981884292228309 0.6981872333005112 5.910937007913564e-07 -0.09498649908898474 -1.2049 0.6981910943303531 0.6981898849481616 5.91616545780882e-07 -0.09498798392932015 -1.205 0.6981937586645626 0.6981925358146999 5.919965745948552e-07 -0.09498946834119369 -1.2051 0.6981964222241623 0.6981951859018598 5.922337388969412e-07 -0.09499095232472232 -1.2052 0.6981990850078548 0.6981978352113754 5.923280225195171e-07 -0.09499243588002299 -1.2053 0.6982017470143423 0.69820048374498 5.922794414220389e-07 -0.09499391900721245 -1.2054 0.6982044082423287 0.698203131504407 5.92088043718797e-07 -0.09499540170640773 -1.2055 0.6982070686905171 0.6982057784913882 5.917539096650382e-07 -0.09499688397772556 -1.2056000000000002 0.6982097283576132 0.6982084247076547 5.912771515459436e-07 -0.09499836582128278 -1.2057 0.6982123872423234 0.6982110701549354 5.906579138431622e-07 -0.09499984723719614 -1.2058 0.698215045343356 0.698213714834958 5.898963729294993e-07 -0.09500132822558242 -1.2059000000000002 0.6982177026594216 0.6982163587494473 5.889927372770831e-07 -0.09500280878655834 -1.206 0.6982203591892333 0.6982190019001254 5.879472471520542e-07 -0.0950042889202405 -1.2061000000000002 0.6982230149315072 0.6982216442887121 5.867601747255868e-07 -0.0950057686267457 -1.2062 0.6982256698849623 0.6982242859169236 5.85431824060012e-07 -0.0950072479061905 -1.2063 0.6982283240483211 0.6982269267864722 5.839625306924834e-07 -0.09500872675869151 -1.2064000000000001 0.6982309774203103 0.6982295668990663 5.823526620651887e-07 -0.0950102051843653 -1.2065 0.6982336299996608 0.6982322062564105 5.806026169702383e-07 -0.09501168318332849 -1.2066000000000001 0.6982362817851075 0.698234844860204 5.787128256884433e-07 -0.09501316075569755 -1.2067 0.6982389327753906 0.6982374827121414 5.766837499476818e-07 -0.09501463790158893 -1.2067999999999999 0.6982415829692556 0.698240119813912 5.745158825065655e-07 -0.09501611462111918 -1.2069 0.6982442323654532 0.6982427561671996 5.722097474042398e-07 -0.0950175909144047 -1.207 0.6982468809627399 0.6982453917736822 5.697658995718058e-07 -0.09501906678156197 -1.2071 0.6982495287598787 0.6982480266350306 5.671849248184424e-07 -0.09502054222270727 -1.2072 0.6982521757556388 0.6982506607529099 5.644674396232396e-07 -0.095022017237957 -1.2073 0.6982548219487967 0.6982532941289781 5.616140910935652e-07 -0.09502349182742756 -1.2074 0.6982574673381354 0.6982559267648853 5.586255567013865e-07 -0.09502496599123514 -1.2075 0.6982601119224456 0.6982585586622752 5.555025442138817e-07 -0.09502643972949604 -1.2076000000000002 0.6982627557005261 0.6982611898227824 5.52245791415884e-07 -0.09502791304232655 -1.2077 0.6982653986711835 0.698263820248034 5.488560660682484e-07 -0.09502938592984284 -1.2078 0.6982680408332328 0.6982664499396486 5.453341656025401e-07 -0.09503085839216113 -1.2079000000000002 0.698270682185498 0.6982690788992353 5.416809170794012e-07 -0.09503233042939759 -1.208 0.6982733227268119 0.6982717071283946 5.378971768138507e-07 -0.09503380204166828 -1.2081000000000002 0.6982759624560168 0.6982743346287177 5.339838302920175e-07 -0.09503527322908942 -1.2082 0.6982786013719644 0.6982769614017853 5.29941791990729e-07 -0.095036743991777 -1.2083 0.6982812394735168 0.6982795874491687 5.257720051415893e-07 -0.09503821432984712 -1.2084000000000001 0.6982838767595461 0.6982822127724285 5.214754413562783e-07 -0.09503968424341577 -1.2085 0.6982865132289351 0.6982848373731146 5.170531006265522e-07 -0.09504115373259898 -1.2086000000000001 0.6982891488805769 0.6982874612527659 5.125060110328095e-07 -0.09504262279751263 -1.2087 0.6982917837133769 0.6982900844129105 5.078352283971466e-07 -0.0950440914382728 -1.2087999999999999 0.698294417726251 0.6982927068550642 5.030418361723354e-07 -0.09504555965499528 -1.2089 0.698297050918127 0.6982953285807316 4.981269450810011e-07 -0.09504702744779601 -1.209 0.698299683287945 0.6982979495914048 4.930916929074547e-07 -0.09504849481679087 -1.2091 0.6983023148346572 0.6983005698885635 4.879372442617713e-07 -0.09504996176209562 -1.2092 0.6983049455572287 0.6983031894736746 4.826647903022341e-07 -0.09505142828382611 -1.2093 0.6983075754546373 0.6983058083481923 4.772755484161451e-07 -0.09505289438209813 -1.2094 0.6983102045258738 0.6983084265135573 4.717707619977807e-07 -0.09505436005702737 -1.2095 0.6983128327699422 0.6983110439711968 4.6615170007369144e-07 -0.09505582530872952 -1.2096000000000002 0.6983154601858609 0.6983136607225244 4.604196571222907e-07 -0.09505729013732038 -1.2097 0.6983180867726618 0.6983162767689395 4.5457595274772666e-07 -0.09505875454291553 -1.2098 0.6983207125293912 0.6983188921118268 4.4862193127048755e-07 -0.09506021852563062 -1.2099000000000002 0.6983233374551097 0.6983215067525568 4.4255896156086827e-07 -0.09506168208558122 -1.21 0.6983259615488927 0.6983241206924855 4.3638843660182003e-07 -0.095063145222883 -1.2101000000000002 0.6983285848098307 0.6983267339329531 4.301117733432336e-07 -0.09506460793765147 -1.2102 0.6983312072370292 0.6983293464752847 4.237304121676444e-07 -0.09506607023000208 -1.2103 0.6983338288296096 0.69833195832079 4.1724581668900473e-07 -0.09506753210005042 -1.2104000000000001 0.6983364495867087 0.6983345694707626 4.1065947337798336e-07 -0.09506899354791193 -1.2105 0.6983390695074793 0.6983371799264799 4.0397289126359315e-07 -0.095070454573702 -1.2106000000000001 0.6983416885910905 0.6983397896892036 3.971876015307352e-07 -0.0950719151775361 -1.2107 0.6983443068367277 0.6983423987601785 3.903051571663152e-07 -0.09507337535952963 -1.2107999999999999 0.6983469242435933 0.6983450071406321 3.833271327094434e-07 -0.09507483511979792 -1.2109 0.6983495408109063 0.6983476148317757 3.7625512373795633e-07 -0.09507629445845625 -1.211 0.6983521565379026 0.698350221834803 3.690907466394333e-07 -0.09507775337562001 -1.2111 0.6983547714238361 0.6983528281508906 3.6183563811853503e-07 -0.09507921187140446 -1.2112 0.6983573854679772 0.698355433781197 3.5449145493332557e-07 -0.09508066994592479 -1.2113 0.698359998669615 0.6983580387268626 3.4705987347199985e-07 -0.09508212759929621 -1.2114 0.6983626110280563 0.6983606429890108 3.395425893643056e-07 -0.09508358483163398 -1.2115 0.6983652225426258 0.6983632465687459 3.3194131708602637e-07 -0.09508504164305322 -1.2116000000000002 0.6983678332126667 0.698365849467154 3.24257789605098e-07 -0.09508649803366906 -1.2117 0.6983704430375407 0.6983684516853024 3.164937579722138e-07 -0.0950879540035966 -1.2118 0.6983730520166285 0.6983710532242395 3.086509908906132e-07 -0.09508940955295095 -1.2119000000000002 0.6983756601493291 0.6983736540849953 3.0073127435525926e-07 -0.09509086468184715 -1.212 0.6983782674350612 0.6983762542685801 2.9273641122262717e-07 -0.09509231939040025 -1.2121000000000002 0.6983808738732622 0.6983788537759847 2.8466822083600407e-07 -0.0950937736787252 -1.2122 0.6983834794633896 0.6983814526081806 2.7652853852588866e-07 -0.095095227546937 -1.2123 0.6983860842049199 0.6983840507661201 2.6831921529080205e-07 -0.09509668099515062 -1.2124000000000001 0.6983886880973494 0.6983866482507343 2.600421173601375e-07 -0.09509813402348088 -1.2125 0.698391291140195 0.6983892450629353 2.5169912571537667e-07 -0.09509958663204274 -1.2126000000000001 0.6983938933329925 0.6983918412036149 2.4329213567375607e-07 -0.09510103882095099 -1.2127000000000001 0.6983964946752992 0.6983944366736444 2.3482305649968893e-07 -0.09510249059032054 -1.2127999999999999 0.6983990951666919 0.698397031473875 2.262938109884316e-07 -0.09510394194026621 -1.2129 0.6984016948067682 0.6983996256051366 2.177063349248498e-07 -0.0951053928709027 -1.213 0.6984042935951458 0.6984022190682388 2.0906257675729067e-07 -0.09510684338234471 -1.2131 0.698406891531464 0.6984048118639705 2.00364497118799e-07 -0.09510829347470708 -1.2132 0.6984094886153824 0.6984074039930994 1.916140683171086e-07 -0.09510974314810448 -1.2133 0.6984120848465825 0.6984099954563721 1.8281327398075864e-07 -0.0951111924026516 -1.2134 0.6984146802247653 0.6984125862545139 1.7396410858724898e-07 -0.09511264123846301 -1.2135 0.6984172747496543 0.6984151763882286 1.6506857699813415e-07 -0.09511408965565334 -1.2136000000000002 0.6984198684209938 0.6984177658581991 1.5612869396289253e-07 -0.09511553765433715 -1.2137 0.6984224612385498 0.6984203546650865 1.4714648374769546e-07 -0.09511698523462904 -1.2138 0.6984250532021098 0.6984229428095301 1.381239796045819e-07 -0.09511843239664355 -1.2139000000000002 0.6984276443114825 0.6984255302921474 1.2906322335512477e-07 -0.09511987914049508 -1.214 0.698430234566499 0.6984281171135346 1.1996626492205564e-07 -0.0951213254662982 -1.2141000000000002 0.6984328239670119 0.6984307032742654 1.1083516184354214e-07 -0.09512277137416734 -1.2142 0.6984354125128951 0.6984332887748916 1.0167197882562928e-07 -0.09512421686421685 -1.2143 0.6984380002040451 0.698435873615944 9.247878728080305e-08 -0.09512566193656119 -1.2144000000000001 0.6984405870403805 0.6984384577979301 8.325766482492059e-08 -0.09512710659131476 -1.2145 0.6984431730218412 0.6984410413213353 7.40106948660807e-08 -0.09512855082859178 -1.2146000000000001 0.69844575814839 0.6984436241866234 6.473996609634991e-08 -0.09512999464850665 -1.2147000000000001 0.6984483424200114 0.6984462063942352 5.5447572018182956e-08 -0.09513143805117356 -1.2147999999999999 0.6984509258367122 0.69844878794459 4.6135610479516864e-08 -0.0951328810367068 -1.2149 0.6984535083985217 0.6984513688380842 3.680618319672202e-08 -0.09513432360522067 -1.215 0.6984560901054911 0.6984539490750918 2.7461395293165713e-08 -0.09513576575682928 -1.2151 0.6984586709576943 0.698456528655965 1.810335481348957e-08 -0.09513720749164685 -1.2152 0.6984612509552273 0.698459107581032 8.734172245693228e-09 -0.09513864880978745 -1.2153 0.6984638300982083 0.6984616858506006 -6.440399429041843e-10 -0.09514008971136528 -1.2154 0.6984664083867781 0.6984642634649545 -1.0029167798325522e-08 -0.09514153019649431 -1.2155 0.6984689858211002 0.698466840424356 -1.94190963383363e-08 -0.09514297026528878 -1.2156000000000002 0.6984715624013599 0.6984694167290437 -2.881171004510616e-08 -0.09514440991786254 -1.2157 0.6984741381277653 0.6984719923792351 -3.820489332968108e-08 -0.09514584915432972 -1.2158 0.6984767130005467 0.6984745673751237 -4.759653101624227e-08 -0.0951472879748042 -1.2159 0.698479287019957 0.698477141716882 -5.698450881367993e-08 -0.09514872637940003 -1.216 0.6984818601862711 0.6984797154046589 -6.636671379470216e-08 -0.09515016436823108 -1.2161000000000002 0.6984844324997865 0.6984822884385813 -7.574103486800501e-08 -0.09515160194141123 -1.2162 0.6984870039608231 0.6984848608187535 -8.510536325580936e-08 -0.09515303909905433 -1.2163 0.6984895745697228 0.6984874325452577 -9.445759296955458e-08 -0.09515447584127425 -1.2164000000000001 0.6984921443268504 0.6984900036181536 -1.0379562127849074e-07 -0.09515591216818485 -1.2165 0.6984947132325916 0.6984925740374781 -1.1311734918889593e-07 -0.0951573480798998 -1.2166000000000001 0.698497281287356 0.6984951438032467 -1.2242068190421174e-07 -0.09515878357653296 -1.2167000000000001 0.698499848491574 0.6984977129154519 -1.3170352931336782e-07 -0.09516021865819799 -1.2167999999999999 0.6985024148456985 0.6985002813740643 -1.4096380644874895e-07 -0.0951616533250086 -1.2169 0.6985049803502048 0.6985028491790328 -1.5019943394416202e-07 -0.09516308757707856 -1.217 0.6985075450055893 0.6985054163302835 -1.594083385361711e-07 -0.09516452141452142 -1.2171 0.6985101088123711 0.698507982827721 -1.6858845349257412e-07 -0.09516595483745081 -1.2172 0.6985126717710903 0.6985105486712277 -1.7773771908771718e-07 -0.09516738784598033 -1.2173 0.69851523388231 0.6985131138606644 -1.8685408308127816e-07 -0.0951688204402236 -1.2174 0.6985177951466135 0.6985156783958699 -1.959355011606212e-07 -0.09517025262029404 -1.2175 0.6985203555646062 0.6985182422766616 -2.049799374022332e-07 -0.0951716843863052 -1.2176000000000002 0.6985229151369153 0.6985208055028356 -2.1398536472275187e-07 -0.09517311573837067 -1.2177 0.698525473864189 0.6985233680741657 -2.229497653612189e-07 -0.09517454667660377 -1.2178 0.6985280317470968 0.698525929990405 -2.318711312815358e-07 -0.09517597720111798 -1.2179 0.6985305887863291 0.6985284912512851 -2.4074746467553365e-07 -0.0951774073120267 -1.218 0.698533144982598 0.698531051856517 -2.495767783723679e-07 -0.09517883700944334 -1.2181000000000002 0.698535700336636 0.6985336118057897 -2.583570963103632e-07 -0.09518026629348118 -1.2182 0.6985382548491965 0.6985361710987719 -2.670864539637552e-07 -0.09518169516425361 -1.2183 0.6985408085210534 0.6985387297351114 -2.757628987624938e-07 -0.09518312362187382 -1.2184000000000001 0.6985433613530012 0.6985412877144356 -2.8438449057449633e-07 -0.09518455166645512 -1.2185 0.6985459133458551 0.6985438450363513 -2.92949302115042e-07 -0.09518597929811079 -1.2186000000000001 0.6985484645004505 0.6985464017004446 -3.014554193631058e-07 -0.09518740651695401 -1.2187000000000001 0.6985510148176424 0.6985489577062818 -3.099009420401422e-07 -0.09518883332309797 -1.2187999999999999 0.6985535642983062 0.6985515130534088 -3.1828398394662116e-07 -0.0951902597166558 -1.2189 0.6985561129433371 0.6985540677413521 -3.2660267346856786e-07 -0.09519168569774068 -1.219 0.6985586607536495 0.6985566217696179 -3.348551539800182e-07 -0.09519311126646565 -1.2191 0.6985612077301779 0.698559175137693 -3.4303958424547476e-07 -0.09519453642294379 -1.2192 0.6985637538738757 0.6985617278450447 -3.5115413876685153e-07 -0.09519596116728817 -1.2193 0.6985662991857156 0.6985642798911214 -3.591970082900131e-07 -0.09519738549961176 -1.2194 0.698568843666689 0.6985668312753519 -3.671664001725361e-07 -0.09519880942002762 -1.2195 0.6985713873178067 0.6985693819971466 -3.750605387653483e-07 -0.09520023292864861 -1.2196000000000002 0.6985739301400973 0.6985719320558967 -3.8287766582906224e-07 -0.09520165602558775 -1.2197 0.6985764721346085 0.6985744814509756 -3.906160409433701e-07 -0.09520307871095791 -1.2198 0.6985790133024059 0.6985770301817377 -3.9827394183317155e-07 -0.095204500984872 -1.2199 0.6985815536445729 0.6985795782475195 -4.058496647779686e-07 -0.09520592284744286 -1.22 0.6985840931622112 0.6985821256476399 -4.1334152505595467e-07 -0.09520734429878332 -1.2201000000000002 0.6985866318564398 0.6985846723813993 -4.207478572285095e-07 -0.09520876533900616 -1.2202 0.698589169728395 0.6985872184480812 -4.280670155426547e-07 -0.09521018596822416 -1.2203 0.6985917067792309 0.698589763846952 -4.352973743473876e-07 -0.0952116061865501 -1.2204000000000002 0.6985942430101176 0.6985923085772605 -4.4243732836429794e-07 -0.09521302599409665 -1.2205 0.6985967784222429 0.6985948526382388 -4.4948529309696283e-07 -0.09521444539097651 -1.2206000000000001 0.6985993130168104 0.6985973960291025 -4.5643970517789123e-07 -0.0952158643773024 -1.2207000000000001 0.6986018467950401 0.6985999387490505 -4.6329902272240764e-07 -0.09521728295318682 -1.2207999999999999 0.6986043797581687 0.6986024807972657 -4.700617256339634e-07 -0.09521870111874245 -1.2209 0.6986069119074478 0.6986050221729155 -4.7672631599271487e-07 -0.0952201188740819 -1.221 0.6986094432441461 0.6986075628751507 -4.832913183677734e-07 -0.09522153621931773 -1.2211 0.6986119737695458 0.6986101029031075 -4.897552801225169e-07 -0.09522295315456245 -1.2212 0.6986145034849451 0.6986126422559062 -4.961167717545956e-07 -0.09522436967992855 -1.2213 0.698617032391657 0.6986151809326524 -5.023743871873654e-07 -0.09522578579552843 -1.2214 0.6986195604910093 0.6986177189324374 -5.085267441515273e-07 -0.09522720150147464 -1.2215 0.6986220877843439 0.6986202562543372 -5.145724844418664e-07 -0.09522861679787953 -1.2216000000000002 0.6986246142730168 0.6986227928974146 -5.205102741739909e-07 -0.09523003168485555 -1.2217 0.698627139958398 0.6986253288607175 -5.2633880411046e-07 -0.09523144616251503 -1.2218 0.6986296648418706 0.6986278641432806 -5.3205679006324e-07 -0.09523286023097027 -1.2219 0.6986321889248317 0.6986303987441256 -5.376629729700322e-07 -0.09523427389033365 -1.222 0.6986347122086909 0.69863293266226 -5.43156119310606e-07 -0.0952356871407174 -1.2221000000000002 0.6986372346948706 0.6986354658966795 -5.485350213912943e-07 -0.09523709998223376 -1.2222 0.6986397563848061 0.6986379984463669 -5.537984974768317e-07 -0.09523851241499504 -1.2223 0.6986422772799443 0.6986405303102923 -5.589453922205667e-07 -0.09523992443911336 -1.2224000000000002 0.6986447973817442 0.6986430614874138 -5.639745767893611e-07 -0.0952413360547009 -1.2225 0.6986473166916767 0.6986455919766787 -5.68884949161963e-07 -0.09524274726186983 -1.2226000000000001 0.6986498352112238 0.6986481217770221 -5.736754343788064e-07 -0.09524415806073228 -1.2227000000000001 0.6986523529418784 0.6986506508873676 -5.783449847224231e-07 -0.09524556845140028 -1.2227999999999999 0.6986548698851447 0.6986531793066286 -5.828925800921425e-07 -0.09524697843398594 -1.2229 0.6986573860425369 0.6986557070337078 -5.873172280179695e-07 -0.09524838800860135 -1.223 0.6986599014155791 0.6986582340674972 -5.916179639936514e-07 -0.09524979717535836 -1.2231 0.698662416005806 0.6986607604068795 -5.957938517681116e-07 -0.09525120593436906 -1.2232 0.6986649298147614 0.6986632860507274 -5.99843983373205e-07 -0.09525261428574541 -1.2233 0.6986674428439986 0.6986658109979038 -6.037674794151515e-07 -0.0952540222295993 -1.2234 0.6986699550950797 0.6986683352472632 -6.075634892688253e-07 -0.09525542976604268 -1.2235 0.6986724665695753 0.6986708587976509 -6.112311912720436e-07 -0.09525683689518731 -1.2236000000000002 0.6986749772690648 0.6986733816479043 -6.147697928088336e-07 -0.09525824361714516 -1.2237 0.6986774871951351 0.6986759037968521 -6.181785306702547e-07 -0.09525964993202801 -1.2238 0.6986799963493815 0.6986784252433154 -6.214566710266434e-07 -0.09526105583994769 -1.2239 0.698682504733406 0.6986809459861074 -6.246035096357794e-07 -0.09526246134101586 -1.224 0.6986850123488177 0.6986834660240351 -6.276183720649309e-07 -0.09526386643534436 -1.2241000000000002 0.6986875191972333 0.6986859853558974 -6.305006138296321e-07 -0.09526527112304485 -1.2242 0.6986900252802748 0.6986885039804875 -6.332496203798055e-07 -0.095266675404229 -1.2243 0.6986925305995713 0.6986910218965923 -6.358648074605844e-07 -0.09526807927900852 -1.2244000000000002 0.6986950351567571 0.698693539102992 -6.383456210429239e-07 -0.095269482747495 -1.2245 0.6986975389534724 0.6986960555984623 -6.406915375456457e-07 -0.0952708858098 -1.2246000000000001 0.6987000419913622 0.6986985713817726 -6.429020638909488e-07 -0.09527228846603514 -1.2247000000000001 0.6987025442720767 0.6987010864516885 -6.449767376154325e-07 -0.09527369071631203 -1.2247999999999999 0.6987050457972701 0.6987036008069698 -6.469151271060181e-07 -0.09527509256074204 -1.2249 0.6987075465686015 0.6987061144463729 -6.487168314611713e-07 -0.09527649399943681 -1.225 0.6987100465877332 0.6987086273686497 -6.503814806851915e-07 -0.09527789503250778 -1.2251 0.6987125458563314 0.6987111395725487 -6.519087357576003e-07 -0.09527929566006631 -1.2252 0.698715044376065 0.6987136510568152 -6.532982888413086e-07 -0.09528069588222382 -1.2253 0.6987175421486065 0.6987161618201914 -6.54549862977305e-07 -0.0952820956990918 -1.2254 0.6987200391756305 0.6987186718614167 -6.556632125148676e-07 -0.0952834951107815 -1.2255 0.6987225354588138 0.6987211811792283 -6.566381230144192e-07 -0.09528489411740428 -1.2256000000000002 0.6987250309998354 0.6987236897723617 -6.574744111920161e-07 -0.09528629271907152 -1.2257 0.6987275258003753 0.6987261976395504 -6.581719251969043e-07 -0.0952876909158944 -1.2258 0.6987300198621149 0.6987287047795263 -6.587305443617186e-07 -0.09528908870798415 -1.2259 0.6987325131867368 0.6987312111910213 -6.591501793967725e-07 -0.09529048609545207 -1.226 0.6987350057759241 0.6987337168727659 -6.594307723623016e-07 -0.09529188307840936 -1.2261000000000002 0.6987374976313595 0.6987362218234902 -6.595722966268314e-07 -0.09529327965696713 -1.2262 0.6987399887547262 0.6987387260419247 -6.595747569504429e-07 -0.09529467583123655 -1.2263 0.6987424791477066 0.6987412295268003 -6.594381894292622e-07 -0.09529607160132873 -1.2264000000000002 0.6987449688119828 0.6987437322768484 -6.591626614121937e-07 -0.09529746696735479 -1.2265 0.6987474577492352 0.6987462342908011 -6.587482716396975e-07 -0.09529886192942577 -1.2266000000000001 0.6987499459611426 0.6987487355673925 -6.581951500911343e-07 -0.09530025648765267 -1.2267000000000001 0.698752433449383 0.6987512361053578 -6.575034579292538e-07 -0.09530165064214653 -1.2268 0.6987549202156311 0.6987537359034344 -6.566733875557063e-07 -0.09530304439301829 -1.2269 0.6987574062615604 0.6987562349603622 -6.557051624861421e-07 -0.09530443774037896 -1.227 0.6987598915888402 0.6987587332748837 -6.545990373363342e-07 -0.0953058306843394 -1.2271 0.698762376199138 0.6987612308457445 -6.533552976556445e-07 -0.09530722322501059 -1.2272 0.6987648600941171 0.6987637276716928 -6.519742600658018e-07 -0.09530861536250332 -1.2273 0.6987673432754373 0.6987662237514817 -6.504562719833462e-07 -0.0953100070969285 -1.2274 0.6987698257447543 0.6987687190838673 -6.488017115641176e-07 -0.09531139842839692 -1.2275 0.6987723075037192 0.6987712136676104 -6.470109876893781e-07 -0.09531278935701935 -1.2276000000000002 0.6987747885539786 0.6987737075014763 -6.45084539785401e-07 -0.0953141798829066 -1.2277 0.6987772688971738 0.6987762005842353 -6.430228378095926e-07 -0.09531557000616936 -1.2278 0.6987797485349412 0.6987786929146629 -6.408263820562032e-07 -0.09531695972691834 -1.2279 0.6987822274689109 0.6987811844915406 -6.384957030730609e-07 -0.09531834904526429 -1.228 0.698784705700707 0.6987836753136554 -6.360313614672819e-07 -0.09531973796131779 -1.2281000000000002 0.698787183231948 0.6987861653798002 -6.334339479330264e-07 -0.09532112647518948 -1.2282 0.6987896600642449 0.6987886546887755 -6.307040828906763e-07 -0.09532251458698998 -1.2283 0.6987921361992021 0.6987911432393876 -6.278424164729568e-07 -0.09532390229682988 -1.2284000000000002 0.6987946116384167 0.6987936310304508 -6.248496284416705e-07 -0.09532528960481969 -1.2285 0.6987970863834781 0.6987961180607863 -6.217264278685075e-07 -0.09532667651106996 -1.2286000000000001 0.698799560435968 0.6987986043292236 -6.184735530795349e-07 -0.09532806301569118 -1.2287000000000001 0.6988020337974594 0.6988010898345998 -6.150917713498849e-07 -0.09532944911879376 -1.2288000000000001 0.6988045064695172 0.6988035745757608 -6.115818788759997e-07 -0.09533083482048824 -1.2289 0.6988069784536979 0.698806058551561 -6.079447005397087e-07 -0.09533222012088499 -1.229 0.6988094497515478 0.698808541760864 -6.041810897416955e-07 -0.09533360502009439 -1.2291 0.6988119203646044 0.6988110242025427 -6.002919280267971e-07 -0.09533498951822679 -1.2292 0.6988143902943953 0.6988135058754795 -5.962781250840044e-07 -0.0953363736153925 -1.2293000000000003 0.6988168595424383 0.6988159867785668 -5.921406184827838e-07 -0.0953377573117019 -1.2294 0.6988193281102408 0.6988184669107074 -5.878803733955218e-07 -0.09533914060726521 -1.2295 0.6988217959992995 0.6988209462708138 -5.834983824448692e-07 -0.0953405235021927 -1.2296 0.6988242632110999 0.6988234248578107 -5.78995665440063e-07 -0.09534190599659459 -1.2297 0.6988267297471171 0.6988259026706325 -5.74373269154882e-07 -0.09534328809058111 -1.2298000000000002 0.698829195608814 0.698828379708226 -5.696322670223353e-07 -0.09534466978426237 -1.2299 0.6988316607976419 0.6988308559695489 -5.64773758968129e-07 -0.09534605107774856 -1.23 0.6988341253150407 0.698833331453571 -5.59798871091477e-07 -0.09534743197114981 -1.2301000000000002 0.6988365891624374 0.6988358061592744 -5.547087554985675e-07 -0.09534881246457616 -1.2302 0.698839052341246 0.6988382800856541 -5.49504589913985e-07 -0.0953501925581377 -1.2303000000000002 0.6988415148528685 0.698840753231717 -5.441875774725435e-07 -0.0953515722519445 -1.2304000000000002 0.6988439766986936 0.6988432255964834 -5.38758946497242e-07 -0.09535295154610651 -1.2305 0.698846437880096 0.6988456971789871 -5.332199501176249e-07 -0.09535433044073371 -1.2306000000000001 0.6988488983984378 0.698848167978275 -5.275718659644713e-07 -0.0953557089359361 -1.2307000000000001 0.6988513582550664 0.6988506379934083 -5.218159960032609e-07 -0.09535708703182362 -1.2308000000000001 0.6988538174513154 0.6988531072234616 -5.159536661733521e-07 -0.09535846472850612 -1.2309 0.6988562759885038 0.6988555756675243 -5.09986226041037e-07 -0.09535984202609349 -1.231 0.698858733867936 0.6988580433247003 -5.039150484595356e-07 -0.0953612189246956 -1.2311 0.698861191090902 0.6988605101941079 -4.977415294787901e-07 -0.09536259542442231 -1.2312 0.6988636476586758 0.6988629762748808 -4.914670876723926e-07 -0.09536397152538334 -1.2313000000000003 0.6988661035725167 0.6988654415661677 -4.850931641306455e-07 -0.09536534722768848 -1.2314 0.698868558833668 0.6988679060671332 -4.78621221960962e-07 -0.09536672253144751 -1.2315 0.6988710134433576 0.6988703697769572 -4.720527459686763e-07 -0.09536809743677009 -1.2316 0.6988734674027969 0.6988728326948357 -4.65389242386427e-07 -0.09536947194376594 -1.2317 0.6988759207131812 0.6988752948199811 -4.5863223843006784e-07 -0.09537084605254471 -1.2318000000000002 0.6988783733756893 0.6988777561516217 -4.5178328202805096e-07 -0.09537221976321604 -1.2319 0.6988808253914833 0.6988802166890031 -4.4484394146060424e-07 -0.09537359307588955 -1.232 0.6988832767617085 0.6988826764313869 -4.3781580497115336e-07 -0.09537496599067483 -1.2321000000000002 0.6988857274874926 0.6988851353780526 -4.3070048039856035e-07 -0.0953763385076814 -1.2322 0.6988881775699463 0.698887593528296 -4.2349959483017896e-07 -0.09537771062701876 -1.2323000000000002 0.6988906270101629 0.6988900508814313 -4.1621479423409324e-07 -0.09537908234879651 -1.2324000000000002 0.6988930758092178 0.6988925074367895 -4.0884774304278393e-07 -0.09538045367312403 -1.2325 0.6988955239681682 0.69889496319372 -4.014001238478171e-07 -0.09538182460011078 -1.2326000000000001 0.6988979714880538 0.6988974181515902 -3.9387363693493826e-07 -0.09538319512986625 -1.2327000000000001 0.6989004183698954 0.6988998723097852 -3.862699999857e-07 -0.0953845652624998 -1.2328000000000001 0.6989028646146953 0.698902325667709 -3.7859094760561707e-07 -0.09538593499812074 -1.2329 0.6989053102234375 0.6989047782247839 -3.7083823089395507e-07 -0.09538730433683845 -1.233 0.6989077551970874 0.698907229980451 -3.630136172286247e-07 -0.09538867327876228 -1.2331 0.6989101995365908 0.6989096809341699 -3.5511888963474236e-07 -0.09539004182400147 -1.2332 0.6989126432428747 0.69891213108542 -3.471558465695246e-07 -0.09539140997266535 -1.2333000000000003 0.6989150863168465 0.6989145804336996 -3.3912630136717636e-07 -0.09539277772486304 -1.2334 0.6989175287593943 0.698917028978526 -3.31032081926641e-07 -0.0953941450807038 -1.2335 0.6989199705713869 0.6989194767194364 -3.2287503026751097e-07 -0.09539551204029684 -1.2336 0.6989224117536725 0.6989219236559879 -3.146570020581829e-07 -0.0953968786037513 -1.2337 0.6989248523070803 0.6989243697877567 -3.0637986625503544e-07 -0.09539824477117628 -1.2338000000000002 0.6989272922324188 0.6989268151143394 -2.980455047207897e-07 -0.09539961054268088 -1.2339 0.698929731530477 0.6989292596353525 -2.8965581162776477e-07 -0.09540097591837424 -1.234 0.6989321702020227 0.6989317033504328 -2.8121269324971054e-07 -0.09540234089836527 -1.2341000000000002 0.6989346082478041 0.6989341462592378 -2.727180673511853e-07 -0.09540370548276317 -1.2342 0.6989370456685483 0.6989365883614445 -2.6417386280938593e-07 -0.09540506967167679 -1.2343000000000002 0.6989394824649621 0.6989390296567511 -2.555820191978142e-07 -0.09540643346521516 -1.2344000000000002 0.6989419186377311 0.6989414701448768 -2.469444863491266e-07 -0.09540779686348719 -1.2345 0.6989443541875207 0.6989439098255606 -2.3826322390757548e-07 -0.09540915986660181 -1.2346000000000001 0.6989467891149745 0.6989463486985632 -2.2954020083634785e-07 -0.09541052247466789 -1.2347000000000001 0.6989492234207159 0.6989487867636659 -2.207773950151093e-07 -0.09541188468779432 -1.2348000000000001 0.6989516571053467 0.6989512240206708 -2.1197679278897597e-07 -0.09541324650608993 -1.2349 0.6989540901694473 0.6989536604694018 -2.0314038854871153e-07 -0.0954146079296635 -1.235 0.6989565226135772 0.6989560961097034 -1.9427018420337117e-07 -0.09541596895862385 -1.2351 0.6989589544382739 0.6989585309414417 -1.8536818877090688e-07 -0.09541732959307966 -1.2352 0.6989613856440544 0.6989609649645039 -1.7643641794795606e-07 -0.09541868983313975 -1.2353000000000003 0.6989638162314131 0.6989633981787992 -1.6747689359983275e-07 -0.09542004967891277 -1.2354 0.6989662462008235 0.6989658305842575 -1.5849164335460242e-07 -0.09542140913050737 -1.2355 0.6989686755527373 0.6989682621808309 -1.4948270008960374e-07 -0.09542276818803225 -1.2356 0.6989711042875844 0.6989706929684927 -1.4045210153593168e-07 -0.09542412685159601 -1.2357 0.6989735324057731 0.6989731229472378 -1.3140188975108158e-07 -0.09542548512130725 -1.2358000000000002 0.6989759599076896 0.6989755521170831 -1.2233411071128908e-07 -0.09542684299727447 -1.2359 0.6989783867936987 0.6989779804780671 -1.1325081381539925e-07 -0.09542820047960633 -1.236 0.698980813064143 0.6989804080302497 -1.0415405144424683e-07 -0.0954295575684112 -1.2361000000000002 0.6989832387193438 0.6989828347737133 -9.504587847840307e-08 -0.0954309142637977 -1.2362 0.6989856637595997 0.6989852607085614 -8.592835184714764e-08 -0.09543227056587424 -1.2363000000000002 0.6989880881851881 0.6989876858349194 -7.68035300583586e-08 -0.09543362647474928 -1.2364000000000002 0.698990511996364 0.6989901101529349 -6.767347273534119e-08 -0.09543498199053116 -1.2365 0.6989929351933606 0.6989925336627771 -5.8540240153656664e-08 -0.09543633711332834 -1.2366000000000001 0.6989953577763892 0.6989949563646372 -4.9405892772746984e-08 -0.0954376918432491 -1.2367000000000001 0.698997779745639 0.6989973782587278 -4.027249077184205e-08 -0.09543904618040183 -1.2368000000000001 0.6990002011012777 0.6989997993452834 -3.1142093587710126e-08 -0.09544040012489478 -1.2369 0.6990026218434506 0.6990022196245611 -2.2016759447691936e-08 -0.09544175367683629 -1.237 0.6990050419722813 0.6990046390968387 -1.2898544908806348e-08 -0.0954431068363345 -1.2371 0.6990074614878719 0.6990070577624163 -3.789504392573417e-09 -0.0954444596034977 -1.2372 0.6990098803903019 0.699009475621616 5.308310278319406e-09 -0.0954458119784341 -1.2373000000000003 0.6990122986796297 0.699011892674781 1.4392850340369523e-08 -0.09544716396125187 -1.2374 0.6990147163558913 0.6990143089222767 2.3462070554598757e-08 -0.09544851555205913 -1.2375 0.6990171334191018 0.6990167243644897 3.251392965801514e-08 -0.09544986675096401 -1.2376 0.6990195498692535 0.6990191390018282 4.1546390832855606e-08 -0.09545121755807454 -1.2377 0.6990219657063185 0.6990215528347224 5.055742216021619e-08 -0.09545256797349888 -1.2378000000000002 0.6990243809302459 0.6990239658636235 5.954499708582528e-08 -0.095453917997345 -1.2379 0.699026795540964 0.6990263780890044 6.850709484591821e-08 -0.09545526762972094 -1.238 0.6990292095383797 0.6990287895113589 7.744170097030711e-08 -0.09545661687073465 -1.2381000000000002 0.6990316229223781 0.6990312001312027 8.634680770044922e-08 -0.0954579657204941 -1.2382 0.6990340356928237 0.6990336099490723 9.522041442833196e-08 -0.09545931417910726 -1.2383000000000002 0.6990364478495593 0.6990360189655248 1.0406052819433853e-07 -0.09546066224668194 -1.2384000000000002 0.6990388593924066 0.6990384271811398 1.1286516408276492e-07 -0.09546200992332615 -1.2385 0.6990412703211661 0.6990408345965162 1.216323457196855e-07 -0.09546335720914761 -1.2386000000000001 0.699043680635618 0.6990432412122751 1.3036010565459222e-07 -0.09546470410425423 -1.2387000000000001 0.6990460903355207 0.6990456470290569 1.390464858599949e-07 -0.09546605060875374 -1.2388000000000001 0.6990484994206132 0.6990480520475241 1.476895381338772e-07 -0.095467396722754 -1.2389000000000001 0.6990509078906123 0.6990504562683586 1.5628732456460237e-07 -0.0954687424463627 -1.239 0.6990533157452153 0.6990528596922634 1.648379179403081e-07 -0.09547008777968752 -1.2391 0.699055722984099 0.6990552623199615 1.7333940216870958e-07 -0.09547143272283622 -1.2392 0.6990581296069196 0.6990576641521961 1.8178987278016923e-07 -0.09547277727591642 -1.2393000000000003 0.6990605356133136 0.6990600651897306 1.9018743723647757e-07 -0.0954741214390358 -1.2394 0.699062941002897 0.6990624654333479 1.985302154686175e-07 -0.09547546521230191 -1.2395 0.6990653457752662 0.6990648648838512 2.068163402341172e-07 -0.09547680859582242 -1.2396 0.6990677499299979 0.6990672635420632 2.1504395757154793e-07 -0.09547815158970484 -1.2397 0.699070153466649 0.6990696614088254 2.2321122716828512e-07 -0.09547949419405669 -1.2398000000000002 0.6990725563847574 0.6990720584849996 2.313163228045978e-07 -0.09548083640898551 -1.2399 0.699074958683841 0.6990744547714662 2.3935743275610433e-07 -0.09548217823459876 -1.24 0.6990773603633992 0.6990768502691251 2.473327601962283e-07 -0.09548351967100388 -1.2401000000000002 0.6990797614229123 0.6990792449788944 2.552405236333488e-07 -0.09548486071830833 -1.2402 0.6990821618618415 0.6990816389017113 2.6307895722305075e-07 -0.09548620137661948 -1.2403000000000002 0.6990845616796295 0.6990840320385316 2.7084631126772507e-07 -0.09548754164604473 -1.2404000000000002 0.6990869608757011 0.6990864243903293 2.7854085250106353e-07 -0.09548888152669142 -1.2405 0.6990893594494623 0.6990888159580968 2.8616086453214784e-07 -0.0954902210186669 -1.2406000000000001 0.6990917574003006 0.6990912067428439 2.937046483242334e-07 -0.09549156012207845 -1.2407000000000001 0.6990941547275864 0.6990935967455986 3.0117052233352704e-07 -0.09549289883703327 -1.2408000000000001 0.699096551430672 0.6990959859674066 3.0855682310593213e-07 -0.0954942371636387 -1.2409000000000001 0.6990989475088926 0.6990983744093308 3.1586190555460414e-07 -0.09549557510200189 -1.241 0.6991013429615652 0.6991007620724514 3.2308414335546765e-07 -0.09549691265223005 -1.2411 0.6991037377879907 0.6991031489578656 3.302219292525277e-07 -0.09549824981443036 -1.2412 0.6991061319874524 0.6991055350666873 3.372736754880812e-07 -0.09549958658870994 -1.2413000000000003 0.6991085255592173 0.6991079204000473 3.4423781408027265e-07 -0.09550092297517594 -1.2414 0.6991109185025357 0.6991103049590924 3.5111279727412237e-07 -0.09550225897393538 -1.2415 0.6991133108166413 0.6991126887449858 3.578970978190821e-07 -0.09550359458509533 -1.2416 0.6991157025007526 0.6991150717589065 3.645892092396519e-07 -0.09550492980876289 -1.2417 0.699118093554072 0.6991174540020493 3.7118764636273616e-07 -0.09550626464504497 -1.2418000000000002 0.6991204839757857 0.6991198354756243 3.7769094544254367e-07 -0.0955075990940486 -1.2419 0.6991228737650653 0.6991222161808572 3.840976645838601e-07 -0.09550893315588074 -1.242 0.699125262921067 0.6991245961189883 3.90406384130626e-07 -0.09551026683064828 -1.2421000000000002 0.6991276514429319 0.6991269752912728 3.9661570679083713e-07 -0.09551160011845813 -1.2422 0.6991300393297872 0.6991293536989809 4.0272425812226675e-07 -0.09551293301941724 -1.2423000000000002 0.6991324265807446 0.6991317313433963 4.08730686782266e-07 -0.09551426553363236 -1.2424000000000002 0.6991348131949024 0.6991341082258173 4.1463366476368613e-07 -0.09551559766121032 -1.2425 0.6991371991713451 0.6991364843475559 4.2043188776264007e-07 -0.09551692940225798 -1.2426000000000001 0.699139584509143 0.6991388597099376 4.261240754768747e-07 -0.09551826075688208 -1.2427000000000001 0.6991419692073536 0.6991412343143006 4.3170897182781554e-07 -0.09551959172518928 -1.2428000000000001 0.699144353265021 0.6991436081619975 4.3718534526587804e-07 -0.09552092230728643 -1.2429000000000001 0.6991467366811767 0.6991459812543921 4.4255198907577897e-07 -0.0955222525032802 -1.243 0.6991491194548388 0.6991483535928615 4.478077215708254e-07 -0.09552358231327712 -1.2431 0.6991515015850142 0.6991507251787952 4.5295138639128707e-07 -0.095524911737384 -1.2432 0.6991538830706968 0.6991530960135939 4.5798185280970793e-07 -0.09552624077570733 -1.2433 0.6991562639108693 0.6991554660986705 4.628980159182561e-07 -0.09552756942835372 -1.2434 0.699158644104503 0.6991578354354497 4.6769879681607396e-07 -0.09552889769542977 -1.2435 0.6991610236505574 0.6991602040253662 4.7238314296316197e-07 -0.09553022557704198 -1.2436 0.6991634025479818 0.6991625718698662 4.769500283885453e-07 -0.09553155307329686 -1.2437 0.6991657807957141 0.6991649389704065 4.813984538637461e-07 -0.0955328801843009 -1.2438000000000002 0.6991681583926825 0.6991673053284544 4.857274471248285e-07 -0.09553420691016057 -1.2439 0.6991705353378047 0.699169670945486 4.899360631499539e-07 -0.09553553325098221 -1.244 0.6991729116299886 0.6991720358229883 4.9402338422877e-07 -0.0955368592068723 -1.2441000000000002 0.699175287268133 0.6991743999624573 4.979885203787449e-07 -0.09553818477793721 -1.2442 0.6991776622511272 0.6991767633653982 5.018306093451663e-07 -0.0955395099642833 -1.2443000000000002 0.6991800365778515 0.6991791260333244 5.055488169064537e-07 -0.09554083476601682 -1.2444000000000002 0.699182410247178 0.6991814879677585 5.091423369990578e-07 -0.09554215918324414 -1.2445 0.6991847832579705 0.699183849170231 5.126103917868496e-07 -0.09554348321607152 -1.2446000000000002 0.6991871556090841 0.6991862096422802 5.159522320913323e-07 -0.09554480686460515 -1.2447000000000001 0.6991895272993669 0.6991885693854523 5.191671374055185e-07 -0.0955461301289513 -1.2448000000000001 0.6991918983276597 0.6991909284013005 5.22254415907808e-07 -0.09554745300921615 -1.2449000000000001 0.6991942686927956 0.6991932866913848 5.252134048921997e-07 -0.09554877550550588 -1.245 0.6991966383936015 0.6991956442572724 5.280434707405357e-07 -0.09555009761792659 -1.2451 0.6991990074288974 0.6991980011005363 5.307440090612792e-07 -0.09555141934658434 -1.2452 0.6992013757974977 0.699200357222756 5.333144448144145e-07 -0.0955527406915854 -1.2453 0.6992037434982106 0.6992027126255165 5.357542325473696e-07 -0.09555406165303566 -1.2454 0.6992061105298388 0.6992050673104079 5.380628563811385e-07 -0.09555538223104122 -1.2455 0.6992084768911802 0.699207421279026 5.402398302045697e-07 -0.09555670242570811 -1.2456 0.6992108425810271 0.6992097745329712 5.422846976604889e-07 -0.09555802223714228 -1.2457 0.6992132075981677 0.6992121270738479 5.441970324371326e-07 -0.0955593416654497 -1.2458000000000002 0.6992155719413862 0.6992144789032652 5.459764381710031e-07 -0.09556066071073628 -1.2459 0.6992179356094621 0.6992168300228354 5.476225485301356e-07 -0.09556197937310791 -1.246 0.699220298601172 0.6992191804341752 5.491350275055318e-07 -0.09556329765267048 -1.2461000000000002 0.6992226609152891 0.6992215301389038 5.505135692029928e-07 -0.09556461554952984 -1.2462 0.6992250225505834 0.6992238791386434 5.517578981067972e-07 -0.09556593306379188 -1.2463000000000002 0.6992273835058225 0.6992262274350187 5.528677690658235e-07 -0.09556725019556234 -1.2464000000000002 0.6992297437797714 0.6992285750296567 5.538429672657941e-07 -0.09556856694494698 -1.2465 0.6992321033711937 0.6992309219241866 5.546833084096869e-07 -0.09556988331205157 -1.2466000000000002 0.6992344622788504 0.6992332681202382 5.553886386205908e-07 -0.09557119929698182 -1.2467000000000001 0.6992368205015019 0.6992356136194433 5.559588345804833e-07 -0.09557251489984339 -1.2468000000000001 0.6992391780379077 0.6992379584234347 5.56393803446964e-07 -0.09557383012074201 -1.2469000000000001 0.6992415348868259 0.6992403025338455 5.566934829920323e-07 -0.09557514495978334 -1.247 0.699243891047015 0.6992426459523091 5.568578414633096e-07 -0.09557645941707295 -1.2471 0.6992462465172328 0.6992449886804588 5.568868776534286e-07 -0.09557777349271643 -1.2472 0.6992486012962378 0.6992473307199274 5.567806209971771e-07 -0.09557908718681934 -1.2473 0.6992509553827886 0.6992496720723473 5.565391313494539e-07 -0.09558040049948718 -1.2474 0.6992533087756454 0.6992520127393496 5.561624991240466e-07 -0.09558171343082553 -1.2475 0.6992556614735694 0.6992543527225648 5.556508451132203e-07 -0.09558302598093989 -1.2476 0.6992580134753236 0.6992566920236202 5.550043207236399e-07 -0.09558433814993567 -1.2477 0.699260364779672 0.6992590306441426 5.542231076016702e-07 -0.09558564993791832 -1.2478000000000002 0.6992627153853819 0.6992613685857557 5.533074178276642e-07 -0.09558696134499324 -1.2479 0.6992650652912227 0.6992637058500806 5.522574937216751e-07 -0.09558827237126584 -1.248 0.6992674144959662 0.6992660424387356 5.510736079128442e-07 -0.0955895830168414 -1.2481000000000002 0.6992697629983885 0.6992683783533357 5.497560631451126e-07 -0.09559089328182535 -1.2482 0.6992721107972681 0.6992707135954923 5.483051922217097e-07 -0.09559220316632296 -1.2483000000000002 0.699274457891388 0.6992730481668127 5.467213580190311e-07 -0.09559351267043943 -1.2484000000000002 0.699276804279535 0.6992753820689002 5.450049533062273e-07 -0.09559482179428012 -1.2485 0.6992791499605004 0.6992777153033534 5.431564006203038e-07 -0.0955961305379502 -1.2486000000000002 0.6992814949330806 0.699280047871766 5.411761522799985e-07 -0.09559743890155485 -1.2487000000000001 0.6992838391960768 0.6992823797757266 5.390646901221041e-07 -0.09559874688519931 -1.2488000000000001 0.6992861827482957 0.6992847110168179 5.368225255986125e-07 -0.09560005448898867 -1.2489000000000001 0.6992885255885497 0.6992870415966175 5.344501994575257e-07 -0.0956013617130281 -1.249 0.699290867715657 0.6992893715166961 5.319482816734666e-07 -0.09560266855742262 -1.2491 0.6992932091284423 0.6992917007786188 5.293173713644128e-07 -0.09560397502227735 -1.2492 0.699295549825737 0.6992940293839435 5.265580965696515e-07 -0.09560528110769732 -1.2493 0.6992978898063795 0.6992963573342208 5.236711141387573e-07 -0.09560658681378754 -1.2494 0.6993002290692157 0.6992986846309943 5.206571095928147e-07 -0.09560789214065307 -1.2495 0.6993025676130982 0.6993010112757999 5.17516796971762e-07 -0.09560919708839878 -1.2496 0.6993049054368885 0.6993033372701656 5.142509185984689e-07 -0.0956105016571297 -1.2497 0.6993072425394553 0.6993056626156104 5.108602449399591e-07 -0.09561180584695067 -1.2498000000000002 0.6993095789196764 0.6993079873136463 5.073455744686317e-07 -0.0956131096579666 -1.2499 0.6993119145764379 0.6993103113657747 5.037077334263396e-07 -0.0956144130902823 -1.25 0.6993142495086355 0.6993126347734893 4.999475756300997e-07 -0.0956157161440027 -1.2501000000000002 0.6993165837151738 0.6993149575382737 4.960659822778046e-07 -0.09561701881923257 -1.2502 0.6993189171949672 0.6993172796616016 4.920638617678108e-07 -0.09561832111607671 -1.2503000000000002 0.6993212499469397 0.6993196011449369 4.879421494768943e-07 -0.09561962303463983 -1.2504000000000002 0.699323581970026 0.6993219219897333 4.837018075243282e-07 -0.09562092457502672 -1.2505 0.6993259132631706 0.6993242421974338 4.793438245359605e-07 -0.095622225737342 -1.2506000000000002 0.6993282438253297 0.6993265617694708 4.748692154915579e-07 -0.09562352652169043 -1.2507000000000001 0.6993305736554697 0.6993288807072651 4.7027902136398403e-07 -0.09562482692817663 -1.2508000000000001 0.6993329027525685 0.6993311990122264 4.6557430899429875e-07 -0.09562612695690523 -1.2509000000000001 0.699335231115616 0.6993335166857528 4.607561707586916e-07 -0.09562742660798083 -1.251 0.6993375587436134 0.6993358337292307 4.5582572438113145e-07 -0.09562872588150806 -1.2511 0.699339885635574 0.6993381501440334 4.5078411270438323e-07 -0.09563002477759142 -1.2512 0.6993422117905241 0.6993404659315225 4.4563250323204073e-07 -0.09563132329633542 -1.2513 0.699344537207502 0.6993427810930466 4.403720881146489e-07 -0.09563262143784462 -1.2514 0.699346861885559 0.6993450956299413 4.350040836847979e-07 -0.09563391920222342 -1.2515 0.6993491858237597 0.6993474095435288 4.295297303044676e-07 -0.09563521658957627 -1.2516 0.6993515090211824 0.6993497228351182 4.2395029200420487e-07 -0.09563651360000763 -1.2517 0.6993538314769182 0.6993520355060046 4.1826705617781235e-07 -0.09563781023362189 -1.2518000000000002 0.6993561531900727 0.6993543475574688 4.1248133331867054e-07 -0.09563910649052335 -1.2519 0.6993584741597659 0.6993566589907785 4.0659445677687645e-07 -0.09564040237081646 -1.252 0.6993607943851314 0.6993589698071856 4.0060778232903216e-07 -0.09564169787460551 -1.2521000000000002 0.699363113865318 0.6993612800079279 3.945226879353836e-07 -0.09564299300199475 -1.2522 0.6993654325994889 0.6993635895942278 3.883405734345091e-07 -0.09564428775308842 -1.2523000000000002 0.6993677505868232 0.6993658985672939 3.820628602033138e-07 -0.0956455821279909 -1.2524000000000002 0.6993700678265142 0.6993682069283178 3.756909908309014e-07 -0.0956468761268063 -1.2525 0.6993723843177715 0.6993705146784759 3.692264287716296e-07 -0.09564816974963881 -1.2526000000000002 0.6993747000598196 0.6993728218189292 3.626706580606154e-07 -0.09564946299659255 -1.2527000000000001 0.6993770150519001 0.6993751283508225 3.560251829043404e-07 -0.09565075586777175 -1.2528000000000001 0.6993793292932697 0.6993774342752843 3.49291527403095e-07 -0.09565204836328046 -1.2529000000000001 0.6993816427832025 0.6993797395934265 3.4247123513464484e-07 -0.09565334048322281 -1.253 0.6993839555209882 0.6993820443063443 3.3556586885585826e-07 -0.09565463222770282 -1.2531 0.6993862675059337 0.6993843484151164 3.2857701010718943e-07 -0.09565592359682454 -1.2532 0.6993885787373626 0.6993866519208043 3.2150625889348916e-07 -0.09565721459069199 -1.2533 0.6993908892146163 0.6993889548244515 3.1435523328154913e-07 -0.09565850520940909 -1.2534 0.6993931989370529 0.6993912571270853 3.0712556903927934e-07 -0.09565979545307984 -1.2535 0.6993955079040483 0.6993935588297144 2.998189192610079e-07 -0.09566108532180817 -1.2536 0.699397816114996 0.6993958599333303 2.924369539997196e-07 -0.09566237481569798 -1.2537 0.6994001235693075 0.6993981604389061 2.8498135988541673e-07 -0.09566366393485314 -1.2538000000000002 0.6994024302664122 0.699400460347397 2.7745383972960225e-07 -0.09566495267937751 -1.2539 0.6994047362057579 0.6994027596597397 2.698561121020071e-07 -0.0956662410493749 -1.254 0.6994070413868111 0.6994050583768527 2.621899110460957e-07 -0.0956675290449492 -1.2541000000000002 0.699409345809056 0.6994073564996357 2.544569855725265e-07 -0.09566881666620412 -1.2542 0.6994116494719961 0.699409654028969 2.4665909930526864e-07 -0.09567010391324338 -1.2543000000000002 0.6994139523751535 0.6994119509657151 2.38798030072207e-07 -0.09567139078617073 -1.2544000000000002 0.6994162545180695 0.6994142473107163 2.308755695165643e-07 -0.09567267728508987 -1.2545 0.6994185559003042 0.6994165430647963 2.2289352267362839e-07 -0.09567396341010438 -1.2546000000000002 0.6994208565214375 0.6994188382287594 2.1485370756829658e-07 -0.09567524916131803 -1.2547000000000001 0.6994231563810684 0.69942113280339 2.0675795479874193e-07 -0.0956765345388344 -1.2548000000000001 0.6994254554788155 0.6994234267894535 1.986081071062018e-07 -0.09567781954275709 -1.2549000000000001 0.6994277538143172 0.6994257201876948 1.9040601895864429e-07 -0.09567910417318964 -1.255 0.6994300513872311 0.6994280129988396 1.8215355617606788e-07 -0.09568038843023566 -1.2551 0.6994323481972357 0.6994303052235931 1.7385259542396225e-07 -0.09568167231399864 -1.2552 0.6994346442440285 0.6994325968626403 1.6550502386289412e-07 -0.09568295582458203 -1.2553 0.6994369395273278 0.6994348879166468 1.5711273865584574e-07 -0.09568423896208939 -1.2554 0.6994392340468717 0.6994371783862567 1.4867764660739247e-07 -0.09568552172662403 -1.2555 0.6994415278024191 0.6994394682720947 1.4020166366410236e-07 -0.09568680411828946 -1.2556 0.6994438207937484 0.6994417575747643 1.3168671450514147e-07 -0.09568808613718903 -1.2557 0.6994461130206596 0.6994440462948489 1.2313473211900128e-07 -0.09568936778342607 -1.2558000000000002 0.6994484044829727 0.6994463344329109 1.1454765736634842e-07 -0.095690649057104 -1.2559 0.6994506951805286 0.6994486219894922 1.0592743849777153e-07 -0.0956919299583261 -1.256 0.6994529851131885 0.6994509089651136 9.727603076173374e-08 -0.09569321048719569 -1.2561000000000002 0.6994552742808349 0.699453195360275 8.859539594313626e-08 -0.09569449064381591 -1.2562 0.6994575626833706 0.6994554811754554 7.988750189841243e-08 -0.0956957704282901 -1.2563000000000002 0.69945985032072 0.699457766411113 7.115432214960249e-08 -0.09569704984072144 -1.2564000000000002 0.6994621371928282 0.6994600510676847 6.23978354003657e-08 -0.09569832888121314 -1.2565 0.699464423299661 0.6994623351455864 5.3620025104034186e-08 -0.09569960754986832 -1.2566000000000002 0.6994667086412059 0.6994646186452123 4.482287901778903e-08 -0.09570088584679011 -1.2567000000000002 0.6994689932174707 0.699466901566936 3.600838874122381e-08 -0.09570216377208163 -1.2568000000000001 0.6994712770284854 0.6994691839111102 2.717854928613317e-08 -0.09570344132584603 -1.2569000000000001 0.6994735600743003 0.699471465678065 1.8335358595994444e-08 -0.09570471850818624 -1.257 0.6994758423549873 0.69947374686811 9.480817116623574e-09 -0.09570599531920537 -1.2571 0.6994781238706393 0.6994760274815338 6.169273338713088e-10 -0.09570727175900638 -1.2572 0.6994804046213711 0.6994783075186031 -8.254306671333367e-09 -0.0957085478276923 -1.2573 0.6994826846073179 0.6994805869795633 -1.71308796861544e-08 -0.09570982352536603 -1.2574 0.6994849638286367 0.6994828658646388 -2.601078581297364e-08 -0.09571109885213058 -1.2575 0.6994872422855054 0.699485144174032 -3.489201892172e-08 -0.09571237380808872 -1.2576 0.6994895199781236 0.6994874219079243 -4.377257310702329e-08 -0.09571364839334341 -1.2577 0.6994917969067119 0.6994896990664761 -5.2650443137128126e-08 -0.09571492260799752 -1.2578000000000003 0.6994940730715122 0.6994919756498259 -6.152362490969253e-08 -0.09571619645215385 -1.2579 0.6994963484727876 0.6994942516580912 -7.039011590314129e-08 -0.09571746992591522 -1.258 0.6994986231108222 0.6994965270913678 -7.924791562731459e-08 -0.09571874302938432 -1.2581000000000002 0.6995008969859219 0.6994988019497304 -8.809502607259878e-08 -0.09572001576266398 -1.2582 0.6995031700984133 0.6995010762332328 -9.692945217385646e-08 -0.09572128812585692 -1.2583000000000002 0.6995054424486438 0.6995033499419071 -1.057492022395537e-07 -0.09572256011906576 -1.2584000000000002 0.6995077140369828 0.6995056230757646 -1.1455228841536491e-07 -0.09572383174239327 -1.2585 0.6995099848638197 0.6995078956347948 -1.233367271247926e-07 -0.095725102995942 -1.2586000000000002 0.6995122549295656 0.699510167618967 -1.3210053952800171e-07 -0.09572637387981461 -1.2587000000000002 0.6995145242346524 0.6995124390282292 -1.4084175195029636e-07 -0.09572764439411376 -1.2588000000000001 0.6995167927795327 0.6995147098625083 -1.495583963392194e-07 -0.09572891453894199 -1.2589000000000001 0.6995190605646799 0.69951698012171 -1.5824851070517232e-07 -0.09573018431440178 -1.259 0.699521327590588 0.6995192498057201 -1.6691013955683065e-07 -0.0957314537205957 -1.2591 0.699523593857772 0.6995215189144025 -1.7554133434696806e-07 -0.09573272275762623 -1.2592 0.6995258593667673 0.6995237874476012 -1.8414015391307603e-07 -0.09573399142559585 -1.2593 0.6995281241181297 0.6995260554051393 -1.927046649127795e-07 -0.095735259724607 -1.2594 0.6995303881124356 0.6995283227868194 -2.0123294223323152e-07 -0.09573652765476204 -1.2595 0.6995326513502818 0.6995305895924238 -2.0972306948377484e-07 -0.0957377952161634 -1.2596 0.6995349138322845 0.6995328558217146 -2.181731393706421e-07 -0.09573906240891346 -1.2597 0.6995371755590813 0.6995351214744334 -2.2658125414104502e-07 -0.09574032923311455 -1.2598000000000003 0.6995394365313288 0.6995373865503018 -2.3494552601338592e-07 -0.09574159568886897 -1.2599 0.6995416967497041 0.6995396510490216 -2.4326407760746904e-07 -0.09574286177627904 -1.26 0.6995439562149035 0.6995419149702745 -2.5153504236083424e-07 -0.09574412749544699 -1.2601000000000002 0.6995462149276435 0.6995441783137224 -2.5975656492774335e-07 -0.09574539284647504 -1.2602 0.6995484728886598 0.6995464410790078 -2.679268016302083e-07 -0.09574665782946548 -1.2603000000000002 0.6995507300987076 0.6995487032657532 -2.7604392086044705e-07 -0.0957479224445204 -1.2604000000000002 0.6995529865585617 0.6995509648735625 -2.8410610347293086e-07 -0.09574918669174205 -1.2605 0.6995552422690157 0.69955322590202 -2.921115432007182e-07 -0.09575045057123255 -1.2606000000000002 0.6995574972308818 0.6995554863506903 -3.000584470960743e-07 -0.09575171408309395 -1.2607000000000002 0.6995597514449918 0.6995577462191199 -3.0794503586006883e-07 -0.09575297722742834 -1.2608000000000001 0.6995620049121958 0.6995600055068364 -3.1576954429013426e-07 -0.09575424000433785 -1.2609000000000001 0.6995642576333627 0.6995622642133481 -3.23530221682522e-07 -0.09575550241392441 -1.261 0.6995665096093794 0.6995645223381455 -3.312253322104719e-07 -0.09575676445629012 -1.2611 0.6995687608411514 0.6995667798807002 -3.388531552850349e-07 -0.0957580261315369 -1.2612 0.6995710113296022 0.6995690368404662 -3.464119859991621e-07 -0.09575928743976672 -1.2613 0.6995732610756731 0.6995712932168796 -3.5390013543301624e-07 -0.0957605483810816 -1.2614 0.6995755100803233 0.699573549009358 -3.613159311188774e-07 -0.09576180895558337 -1.2615 0.6995777583445288 0.6995758042173015 -3.686577173395156e-07 -0.09576306916337388 -1.2616 0.6995800058692838 0.6995780588400933 -3.7592385552370766e-07 -0.095764329004555 -1.2617 0.6995822526555995 0.699580312877099 -3.8311272466257096e-07 -0.0957655884792286 -1.2618000000000003 0.6995844987045039 0.6995825663276671 -3.9022272153160786e-07 -0.09576684758749647 -1.2619 0.6995867440170418 0.6995848191911292 -3.9725226125275626e-07 -0.09576810632946042 -1.262 0.6995889885942745 0.6995870714668002 -4.0419977746092295e-07 -0.09576936470522211 -1.2621000000000002 0.69959123243728 0.6995893231539786 -4.11063722741134e-07 -0.09577062271488335 -1.2622 0.6995934755471523 0.6995915742519467 -4.1784256898241834e-07 -0.09577188035854582 -1.2623000000000002 0.6995957179250012 0.6995938247599705 -4.2453480766924123e-07 -0.09577313763631118 -1.2624000000000002 0.6995979595719526 0.6995960746773005 -4.311389502839602e-07 -0.09577439454828113 -1.2625 0.6996002004891475 0.6995983240031711 -4.376535285496863e-07 -0.09577565109455725 -1.2626000000000002 0.6996024406777429 0.6996005727368015 -4.440770948604955e-07 -0.09577690727524117 -1.2627000000000002 0.69960468013891 0.6996028208773959 -4.504082224549011e-07 -0.09577816309043445 -1.2628000000000001 0.6996069188738356 0.6996050684241432 -4.566455059570873e-07 -0.09577941854023866 -1.2629000000000001 0.6996091568837208 0.6996073153762176 -4.627875614393595e-07 -0.09578067362475527 -1.263 0.6996113941697817 0.6996095617327791 -4.688330269495e-07 -0.09578192834408586 -1.2631000000000001 0.6996136307332473 0.6996118074929729 -4.747805626148516e-07 -0.09578318269833186 -1.2632 0.6996158665753618 0.6996140526559307 -4.80628851121101e-07 -0.09578443668759469 -1.2633 0.6996181016973824 0.6996162972207702 -4.863765978441181e-07 -0.09578569031197581 -1.2634 0.6996203361005803 0.6996185411865954 -4.920225312801674e-07 -0.09578694357157663 -1.2635 0.699622569786239 0.6996207845524972 -4.975654032055021e-07 -0.09578819646649851 -1.2636 0.6996248027556561 0.6996230273175533 -5.030039890441262e-07 -0.09578944899684277 -1.2637 0.6996270350101408 0.6996252694808287 -5.083370880412663e-07 -0.09579070116271075 -1.2638000000000003 0.6996292665510158 0.6996275110413759 -5.135635236797054e-07 -0.09579195296420376 -1.2639 0.6996314973796149 0.699629751998235 -5.186821437561107e-07 -0.09579320440142307 -1.264 0.6996337274972848 0.6996319923504344 -5.236918207904284e-07 -0.09579445547446994 -1.2641000000000002 0.6996359569053832 0.6996342320969902 -5.285914521993562e-07 -0.09579570618344557 -1.2642 0.6996381856052791 0.6996364712369073 -5.333799605322653e-07 -0.09579695652845113 -1.2643000000000002 0.6996404135983534 0.6996387097691796 -5.380562937279398e-07 -0.09579820650958781 -1.2644000000000002 0.699642640885997 0.6996409476927898 -5.426194253088656e-07 -0.0957994561269568 -1.2645 0.6996448674696119 0.6996431850067102 -5.470683547004196e-07 -0.09580070538065917 -1.2646000000000002 0.69964709335061 0.6996454217099022 -5.51402107390464e-07 -0.09580195427079606 -1.2647 0.6996493185304137 0.6996476578013175 -5.556197350820025e-07 -0.0958032027974685 -1.2648000000000001 0.6996515430104546 0.699649893279898 -5.597203160401243e-07 -0.09580445096077755 -1.2649000000000001 0.6996537667921741 0.6996521281445756 -5.637029551752715e-07 -0.09580569876082422 -1.265 0.6996559898770223 0.6996543623942734 -5.675667843069165e-07 -0.09580694619770946 -1.2651000000000001 0.699658212266459 0.6996565960279056 -5.713109622607071e-07 -0.09580819327153432 -1.2652 0.6996604339619521 0.6996588290443775 -5.749346752015327e-07 -0.09580943998239976 -1.2653 0.6996626549649774 0.6996610614425856 -5.784371366474028e-07 -0.09581068633040657 -1.2654 0.6996648752770191 0.6996632932214191 -5.8181758776088e-07 -0.09581193231565571 -1.2655 0.6996670948995694 0.6996655243797592 -5.850752974878581e-07 -0.09581317793824806 -1.2656 0.6996693138341272 0.6996677549164789 -5.882095625991957e-07 -0.09581442319828448 -1.2657 0.6996715320821996 0.699669984830445 -5.912197080654158e-07 -0.09581566809586578 -1.2658000000000003 0.6996737496452992 0.6996722141205167 -5.941050870428288e-07 -0.09581691263109272 -1.2659 0.6996759665249457 0.6996744427855468 -5.9686508101231e-07 -0.09581815680406608 -1.266 0.6996781827226652 0.6996766708243818 -5.994990999874661e-07 -0.0958194006148866 -1.2661000000000002 0.6996803982399896 0.6996788982358626 -6.020065825423915e-07 -0.09582064406365502 -1.2662 0.6996826130784561 0.6996811250188237 -6.043869960753456e-07 -0.09582188715047205 -1.2663000000000002 0.6996848272396075 0.6996833511720946 -6.0663983676712e-07 -0.09582312987543827 -1.2664000000000002 0.6996870407249913 0.6996855766944996 -6.087646297614491e-07 -0.09582437223865438 -1.2665 0.6996892535361598 0.6996878015848582 -6.107609293037886e-07 -0.09582561424022097 -1.2666000000000002 0.69969146567467 0.6996900258419858 -6.126283187690706e-07 -0.09582685588023863 -1.2667 0.6996936771420823 0.6996922494646933 -6.143664107310931e-07 -0.09582809715880794 -1.2668000000000001 0.6996958879399613 0.699694472451788 -6.159748471706861e-07 -0.09582933807602946 -1.2669000000000001 0.6996980980698747 0.6996966948020733 -6.174532993646897e-07 -0.09583057863200363 -1.267 0.6997003075333936 0.6996989165143499 -6.18801468107999e-07 -0.095831818826831 -1.2671000000000001 0.699702516332092 0.6997011375874154 -6.200190837135633e-07 -0.09583305866061204 -1.2672 0.6997047244675461 0.6997033580200642 -6.211059059846313e-07 -0.09583429813344717 -1.2673 0.699706931941334 0.6997055778110898 -6.220617244784288e-07 -0.0958355372454368 -1.2674 0.6997091387550365 0.6997077969592824 -6.22886358270236e-07 -0.0958367759966813 -1.2675 0.6997113449102352 0.6997100154634313 -6.235796562864548e-07 -0.0958380143872811 -1.2676 0.6997135504085129 0.6997122333223242 -6.241414969992976e-07 -0.09583925241733644 -1.2677 0.6997157552514539 0.6997144505347483 -6.245717887320978e-07 -0.09584049008694777 -1.2678000000000003 0.6997179594406429 0.6997166670994894 -6.248704695205332e-07 -0.09584172739621527 -1.2679 0.6997201629776642 0.6997188830153332 -6.250375071403802e-07 -0.09584296434523924 -1.268 0.6997223658641025 0.6997210982810655 -6.250728992046595e-07 -0.09584420093411987 -1.2681000000000002 0.6997245681015426 0.6997233128954724 -6.249766729693462e-07 -0.09584543716295744 -1.2682 0.6997267696915679 0.6997255268573404 -6.247488855137817e-07 -0.09584667303185208 -1.2683000000000002 0.6997289706357614 0.6997277401654567 -6.243896236018953e-07 -0.09584790854090401 -1.2684000000000002 0.6997311709357046 0.6997299528186101 -6.238990036405712e-07 -0.09584914369021333 -1.2685 0.699733370592977 0.6997321648155906 -6.23277171818426e-07 -0.09585037847988018 -1.2686000000000002 0.6997355696091567 0.6997343761551906 -6.225243037727424e-07 -0.09585161291000462 -1.2687 0.699737767985819 0.6997365868362041 -6.216406048392686e-07 -0.09585284698068673 -1.2688000000000001 0.6997399657245372 0.6997387968574278 -6.206263097469078e-07 -0.09585408069202653 -1.2689000000000001 0.6997421628268814 0.6997410062176608 -6.19481682839762e-07 -0.09585531404412402 -1.269 0.6997443592944182 0.6997432149157057 -6.182070177163101e-07 -0.09585654703707919 -1.2691000000000001 0.6997465551287114 0.6997454229503688 -6.168026372987967e-07 -0.09585777967099202 -1.2692 0.6997487503313204 0.6997476303204595 -6.15268893819354e-07 -0.09585901194596241 -1.2693 0.699750944903801 0.6997498370247917 -6.136061685840799e-07 -0.09586024386209036 -1.2694 0.6997531388477041 0.6997520430621831 -6.118148719591598e-07 -0.09586147541947565 -1.2695 0.699755332164576 0.6997542484314565 -6.098954433153558e-07 -0.09586270661821822 -1.2696 0.6997575248559582 0.6997564531314395 -6.078483507365728e-07 -0.09586393745841787 -1.2697 0.6997597169233865 0.6997586571609652 -6.056740911586367e-07 -0.09586516794017445 -1.2698000000000003 0.699761908368391 0.6997608605188718 -6.033731900917383e-07 -0.0958663980635877 -1.2699 0.6997640991924963 0.6997630632040035 -6.009462015232891e-07 -0.0958676278287574 -1.27 0.6997662893972201 0.6997652652152107 -5.98393707806899e-07 -0.09586885723578324 -1.2701000000000002 0.699768478984074 0.6997674665513505 -5.957163194819648e-07 -0.09587008628476495 -1.2702 0.6997706679545628 0.6997696672112865 -5.929146752181591e-07 -0.0958713149758023 -1.2703000000000002 0.6997728563101839 0.6997718671938896 -5.89989441523997e-07 -0.09587254330899486 -1.2704000000000002 0.6997750440524275 0.6997740664980379 -5.86941312677447e-07 -0.09587377128444233 -1.2705 0.6997772311827755 0.6997762651226168 -5.837710106287863e-07 -0.09587499890224425 -1.2706000000000002 0.6997794177027025 0.6997784630665203 -5.8047928469529e-07 -0.0958762261625003 -1.2707 0.6997816036136739 0.6997806603286503 -5.770669114224525e-07 -0.09587745306530994 -1.2708000000000002 0.6997837889171474 0.699782856907917 -5.73534694459088e-07 -0.09587867961077276 -1.2709000000000001 0.6997859736145713 0.6997850528032397 -5.698834643075301e-07 -0.09587990579898824 -1.271 0.6997881577073848 0.6997872480135467 -5.661140781570984e-07 -0.09588113163005586 -1.2711000000000001 0.6997903411970178 0.699789442537776 -5.622274197314425e-07 -0.09588235710407515 -1.2712 0.6997925240848901 0.6997916363748746 -5.582243988860869e-07 -0.09588358222114551 -1.2713 0.6997947063724117 0.6997938295237998 -5.541059517194524e-07 -0.09588480698136632 -1.2714 0.6997968880609824 0.6997960219835192 -5.498730399899898e-07 -0.09588603138483703 -1.2715 0.6997990691519911 0.6997982137530104 -5.45526651268835e-07 -0.09588725543165692 -1.2716 0.6998012496468164 0.6998004048312624 -5.41067798377759e-07 -0.09588847912192539 -1.2717 0.6998034295468252 0.6998025952172748 -5.364975193475341e-07 -0.09588970245574172 -1.2718000000000003 0.6998056088533733 0.6998047849100584 -5.318168771265008e-07 -0.09589092543320518 -1.2719 0.6998077875678053 0.6998069739086357 -5.270269593515842e-07 -0.0958921480544151 -1.272 0.699809965691453 0.699809162212041 -5.221288780291045e-07 -0.09589337031947066 -1.2721000000000002 0.6998121432256367 0.6998113498193206 -5.171237693127329e-07 -0.09589459222847108 -1.2722 0.699814320171664 0.6998135367295333 -5.120127932745078e-07 -0.09589581378151554 -1.2723000000000002 0.6998164965308302 0.69981572294175 -5.067971336203403e-07 -0.09589703497870321 -1.2724000000000002 0.6998186723044175 0.6998179084550551 -5.014779974124584e-07 -0.09589825582013327 -1.2725 0.6998208474936949 0.6998200932685452 -4.960566147779732e-07 -0.09589947630590477 -1.2726000000000002 0.6998230220999178 0.6998222773813307 -4.905342386105072e-07 -0.09590069643611678 -1.2727 0.6998251961243284 0.6998244607925356 -4.849121443550874e-07 -0.09590191621086842 -1.2728000000000002 0.6998273695681549 0.6998266435012973 -4.791916296334464e-07 -0.0959031356302587 -1.2729000000000001 0.6998295424326113 0.6998288255067677 -4.733740139734044e-07 -0.09590435469438667 -1.273 0.6998317147188975 0.6998310068081126 -4.6746063851049735e-07 -0.09590557340335126 -1.2731000000000001 0.6998338864281985 0.6998331874045121 -4.6145286566878774e-07 -0.09590679175725147 -1.2732 0.6998360575616848 0.6998353672951612 -4.5535207886249207e-07 -0.09590800975618623 -1.2733 0.6998382281205118 0.6998375464792701 -4.491596821767918e-07 -0.09590922740025444 -1.2734 0.6998403981058195 0.6998397249560633 -4.4287710000701086e-07 -0.09591044468955501 -1.2735 0.6998425675187329 0.6998419027247814 -4.3650577677412095e-07 -0.09591166162418674 -1.2736 0.6998447363603609 0.6998440797846803 -4.3004717663330805e-07 -0.09591287820424851 -1.2737 0.699846904631797 0.6998462561350314 -4.23502783043761e-07 -0.09591409442983911 -1.2738000000000003 0.6998490723341186 0.6998484317751225 -4.168740984356045e-07 -0.0959153103010574 -1.2739 0.6998512394683867 0.6998506067042569 -4.1016264397397695e-07 -0.09591652581800211 -1.274 0.6998534060356457 0.6998527809217551 -4.0336995907330753e-07 -0.09591774098077198 -1.2741000000000002 0.6998555720369238 0.6998549544269533 -3.964976011475163e-07 -0.09591895578946569 -1.2742 0.699857737473232 0.6998571272192051 -3.8954714515898603e-07 -0.09592017024418198 -1.2743000000000002 0.6998599023455645 0.6998592992978799 -3.825201833687619e-07 -0.09592138434501944 -1.2744000000000002 0.6998620666548983 0.6998614706623656 -3.754183249063403e-07 -0.09592259809207676 -1.2745 0.6998642304021931 0.6998636413120662 -3.68243195415785e-07 -0.09592381148545254 -1.2746000000000002 0.6998663935883912 0.6998658112464041 -3.609964366602103e-07 -0.0959250245252454 -1.2747 0.6998685562144169 0.6998679804648185 -3.536797061540198e-07 -0.09592623721155387 -1.2748000000000002 0.6998707182811768 0.6998701489667666 -3.462946768159614e-07 -0.0959274495444765 -1.2749000000000001 0.6998728797895597 0.6998723167517236 -3.388430365527939e-07 -0.09592866152411184 -1.275 0.6998750407404355 0.6998744838191827 -3.313264879400979e-07 -0.09592987315055829 -1.2751000000000001 0.6998772011346566 0.6998766501686555 -3.237467476949196e-07 -0.09593108442391442 -1.2752000000000001 0.6998793609730569 0.6998788157996715 -3.16105546425971e-07 -0.09593229534427856 -1.2753 0.6998815202564512 0.6998809807117792 -3.084046281826014e-07 -0.09593350591174923 -1.2754 0.699883678985636 0.6998831449045453 -3.0064575004540295e-07 -0.09593471612642475 -1.2755 0.6998858371613885 0.6998853083775558 -2.928306817237547e-07 -0.09593592598840353 -1.2756 0.6998879947844674 0.6998874711304152 -2.849612051950001e-07 -0.09593713549778388 -1.2757 0.6998901518556115 0.6998896331627473 -2.770391142603579e-07 -0.09593834465466411 -1.2758000000000003 0.6998923083755415 0.6998917944741949 -2.690662141251188e-07 -0.0959395534591426 -1.2759 0.6998944643449576 0.6998939550644201 -2.6104432103782327e-07 -0.09594076191131753 -1.276 0.6998966197645413 0.6998961149331044 -2.52975261828825e-07 -0.09594197001128717 -1.2761000000000002 0.6998987746349539 0.6998982740799488 -2.4486087351824337e-07 -0.09594317775914969 -1.2762 0.6999009289568374 0.6999004325046736 -2.367030028961603e-07 -0.09594438515500335 -1.2763000000000002 0.6999030827308141 0.6999025902070195 -2.2850350608200065e-07 -0.09594559219894631 -1.2764000000000002 0.6999052359574858 0.6999047471867461 -2.2026424812901513e-07 -0.09594679889107662 -1.2765 0.6999073886374352 0.6999069034436338 -2.1198710260100784e-07 -0.09594800523149251 -1.2766000000000002 0.6999095407712241 0.6999090589774827 -2.0367395113518594e-07 -0.09594921122029205 -1.2767 0.6999116923593949 0.6999112137881122 -1.9532668300153988e-07 -0.0959504168575733 -1.2768000000000002 0.6999138434024693 0.6999133678753626 -1.8694719468997922e-07 -0.09595162214343432 -1.2769000000000001 0.6999159939009485 0.6999155212390944 -1.78537389493999e-07 -0.09595282707797305 -1.277 0.6999181438553141 0.6999176738791878 -1.7009917703883493e-07 -0.09595403166128756 -1.2771000000000001 0.6999202932660264 0.6999198257955441 -1.6163447287900756e-07 -0.09595523589347582 -1.2772000000000001 0.6999224421335262 0.6999219769880844 -1.531451980767845e-07 -0.09595643977463579 -1.2773 0.6999245904582327 0.6999241274567505 -1.4463327870951892e-07 -0.09595764330486535 -1.2774 0.6999267382405454 0.6999262772015044 -1.36100645496684e-07 -0.0959588464842624 -1.2775 0.6999288854808425 0.6999284262223286 -1.2754923332108925e-07 -0.09596004931292479 -1.2776 0.6999310321794823 0.6999305745192272 -1.1898098080213859e-07 -0.09596125179095048 -1.2777 0.6999331783368012 0.6999327220922235 -1.1039782985694524e-07 -0.09596245391843715 -1.2778000000000003 0.6999353239531165 0.699934868941362 -1.0180172527705922e-07 -0.09596365569548267 -1.2779 0.6999374690287232 0.6999370150667081 -9.319461425402048e-08 -0.09596485712218479 -1.278 0.6999396135638963 0.6999391604683478 -8.457844596736208e-08 -0.09596605819864128 -1.2781000000000002 0.6999417575588899 0.6999413051463874 -7.595517112317374e-08 -0.09596725892494982 -1.2782 0.6999439010139374 0.6999434491009546 -6.73267415238904e-08 -0.09596845930120818 -1.2783000000000002 0.6999460439292512 0.6999455923321969 -5.869510963027458e-08 -0.09596965932751395 -1.2784 0.699948186305023 0.6999477348402834 -5.0062228108002996e-08 -0.09597085900396485 -1.2785 0.6999503281414234 0.6999498766254033 -4.143004939555781e-08 -0.09597205833065847 -1.2786000000000002 0.6999524694386026 0.6999520176877669 -3.280052525574638e-08 -0.09597325730769242 -1.2787 0.69995461019669 0.6999541580276052 -2.4175606341478306e-08 -0.0959744559351643 -1.2788000000000002 0.6999567504157937 0.6999562976451694 -1.5557241747447825e-08 -0.09597565421317161 -1.2789000000000001 0.6999588900960018 0.6999584365407319 -6.947378575206109e-09 -0.0959768521418119 -1.279 0.699961029237381 0.6999605747145856 1.652038505994824e-09 -0.09597804972118268 -1.2791000000000001 0.6999631678399774 0.6999627121670435 1.0239067704809202e-08 -0.09597924695138138 -1.2792000000000001 0.6999653059038169 0.69996484889844 1.881177053800892e-08 -0.0959804438325055 -1.2793 0.6999674434289048 0.6999669849091297 2.7368212274572756e-08 -0.09598164036465251 -1.2794 0.6999695804152253 0.6999691201994871 3.590646236936723e-08 -0.09598283654791975 -1.2795 0.6999717168627422 0.699971254769908 4.442459490029693e-08 -0.0959840323824046 -1.2796 0.699973852771399 0.6999733886208079 5.292068899938329e-08 -0.09598522786820445 -1.2797 0.6999759881411186 0.6999755217526231 6.139282928037393e-08 -0.09598642300541656 -1.2798000000000003 0.6999781229718038 0.69997765416581 6.983910630364853e-08 -0.0959876177941383 -1.2799 0.6999802572633371 0.6999797858608452 7.825761694571498e-08 -0.09598881223446697 -1.28 0.6999823910155805 0.6999819168382252 8.664646488840133e-08 -0.09599000632649977 -1.2801000000000002 0.6999845242283758 0.6999840470984667 9.500376101090335e-08 -0.09599120007033392 -1.2802 0.6999866569015454 0.6999861766421065 1.0332762382866956e-07 -0.09599239346606664 -1.2803000000000002 0.6999887890348913 0.6999883054697011 1.1161617991320427e-07 -0.09599358651379516 -1.2804 0.6999909206281953 0.6999904335818268 1.1986756430840129e-07 -0.09599477921361661 -1.2805 0.6999930516812203 0.6999925609790796 1.2807992097463305e-07 -0.09599597156562811 -1.2806000000000002 0.6999951821937085 0.6999946876620751 1.3625140315304263e-07 -0.09599716356992677 -1.2807 0.6999973121653831 0.6999968136314482 1.4438017383738844e-07 -0.09599835522660964 -1.2808000000000002 0.6999994415959478 0.6999989388878535 1.5246440617650014e-07 -0.09599954653577385 -1.2809000000000001 0.700001570485087 0.7000010634319648 1.605022838489789e-07 -0.09600073749751639 -1.281 0.7000036988324658 0.7000031872644749 1.6849200149687826e-07 -0.09600192811193432 -1.2811000000000001 0.70000582663773 0.7000053103860954 1.7643176514550718e-07 -0.09600311837912456 -1.2812000000000001 0.7000079539005064 0.7000074327975574 1.8431979259200815e-07 -0.0960043082991841 -1.2813 0.7000100806204035 0.7000095544996104 1.921543137627102e-07 -0.09600549787220994 -1.2814 0.7000122067970102 0.7000116754930223 1.999335712092598e-07 -0.09600668709829889 -1.2815 0.7000143324298973 0.7000137957785799 2.076558204243406e-07 -0.09600787597754785 -1.2816 0.7000164575186171 0.7000159153570882 2.1531933022678196e-07 -0.0960090645100537 -1.2817 0.7000185820627038 0.7000180342293707 2.2292238319870927e-07 -0.09601025269591333 -1.2818000000000003 0.7000207060616732 0.7000201523962681 2.304632760741221e-07 -0.09601144053522347 -1.2819 0.7000228295150231 0.7000222698586402 2.379403200442054e-07 -0.09601262802808098 -1.282 0.7000249524222337 0.7000243866173638 2.453518412187661e-07 -0.09601381517458263 -1.2821000000000002 0.700027074782767 0.7000265026733331 2.526961809523609e-07 -0.09601500197482513 -1.2822 0.7000291965960681 0.7000286180274602 2.5997169623981353e-07 -0.09601618842890515 -1.2823000000000002 0.7000313178615643 0.7000307326806743 2.6717676007009805e-07 -0.09601737453691946 -1.2824 0.7000334385786656 0.7000328466339216 2.743097617941004e-07 -0.09601856029896466 -1.2825 0.700035558746766 0.7000349598881652 2.8136910750625743e-07 -0.09601974571513744 -1.2826000000000002 0.7000376783652418 0.7000370724443851 2.883532203706851e-07 -0.09602093078553442 -1.2827 0.7000397974334528 0.7000391843035774 2.9526054097506194e-07 -0.09602211551025214 -1.2828000000000002 0.7000419159507425 0.700041295466755 3.020895276914515e-07 -0.09602329988938724 -1.2829000000000002 0.7000440339164382 0.7000434059349467 3.088386569954915e-07 -0.09602448392303625 -1.283 0.7000461513298512 0.7000455157091975 3.1550642387578876e-07 -0.0960256676112957 -1.2831000000000001 0.7000482681902767 0.7000476247905676 3.2209134209065793e-07 -0.09602685095426204 -1.2832000000000001 0.7000503844969943 0.7000497331801332 3.2859194453588314e-07 -0.09602803395203176 -1.2833 0.7000525002492686 0.7000518408789858 3.3500678352227364e-07 -0.09602921660470133 -1.2834 0.7000546154463486 0.7000539478882316 3.4133443123363083e-07 -0.09603039891236716 -1.2835 0.7000567300874683 0.7000560542089924 3.475734798863428e-07 -0.09603158087512564 -1.2836 0.7000588441718467 0.7000581598424043 3.537225421249013e-07 -0.09603276249307312 -1.2837 0.7000609576986888 0.7000602647896177 3.5978025129251856e-07 -0.09603394376630596 -1.2838000000000003 0.7000630706671851 0.7000623690517975 3.65745261785011e-07 -0.0960351246949205 -1.2839 0.7000651830765119 0.7000644726301231 3.716162493214159e-07 -0.09603630527901312 -1.284 0.7000672949258312 0.7000665755257864 3.7739191122154736e-07 -0.09603748551867997 -1.2841000000000002 0.7000694062142919 0.7000686777399938 3.8307096675294083e-07 -0.09603866541401733 -1.2842 0.7000715169410293 0.7000707792739651 3.8865215730432556e-07 -0.09603984496512141 -1.2843000000000002 0.700073627105166 0.7000728801289331 3.941342467742026e-07 -0.0960410241720886 -1.2844 0.7000757367058106 0.7000749803061428 3.9951602182064505e-07 -0.09604220303501486 -1.2845 0.7000778457420598 0.7000770798068524 4.0479629207640366e-07 -0.0960433815539964 -1.2846000000000002 0.7000799542129976 0.7000791786323324 4.099738905236072e-07 -0.09604455972912937 -1.2847 0.7000820621176959 0.7000812767838651 4.150476735631514e-07 -0.09604573756050988 -1.2848000000000002 0.7000841694552147 0.7000833742627453 4.200165214587881e-07 -0.096046915048234 -1.2849000000000002 0.7000862762246021 0.7000854710702787 4.248793384897809e-07 -0.09604809219239782 -1.285 0.7000883824248948 0.7000875672077824 4.296350532145832e-07 -0.0960492689930973 -1.2851000000000001 0.7000904880551188 0.7000896626765852 4.3428261869982165e-07 -0.09605044545042854 -1.2852000000000001 0.700092593114289 0.7000917574780259 4.3882101277009644e-07 -0.09605162156448749 -1.2853 0.7000946976014089 0.700093851613454 4.4324923818839235e-07 -0.09605279733537005 -1.2854 0.7000968015154728 0.7000959450842299 4.475663228781235e-07 -0.09605397276317225 -1.2855 0.7000989048554643 0.7000980378917234 4.5177132026313904e-07 -0.09605514784798996 -1.2856 0.7001010076203571 0.7001001300373138 4.558633092816011e-07 -0.09605632258991904 -1.2857 0.7001031098091155 0.7001022215223908 4.5984139469129603e-07 -0.09605749698905536 -1.2858000000000003 0.7001052114206944 0.7001043123483524 4.6370470732637337e-07 -0.0960586710454948 -1.2859 0.7001073124540399 0.7001064025166059 4.674524041042849e-07 -0.0960598447593331 -1.286 0.7001094129080895 0.7001084920285673 4.710836683519126e-07 -0.09606101813066613 -1.2861000000000002 0.700111512781772 0.7001105808856607 4.7459771004843e-07 -0.09606219115958964 -1.2862 0.700113612074008 0.7001126690893182 4.779937658044853e-07 -0.09606336384619935 -1.2863000000000002 0.7001157107837106 0.7001147566409802 4.812710991813907e-07 -0.09606453619059102 -1.2864 0.7001178089097848 0.7001168435420935 4.844290007327556e-07 -0.09606570819286026 -1.2865 0.700119906451129 0.700118929794113 4.874667882820427e-07 -0.09606687985310276 -1.2866000000000002 0.700122003406634 0.7001210153985005 4.903838069780786e-07 -0.0960680511714142 -1.2867 0.7001240997751845 0.7001231003567239 4.931794293366876e-07 -0.09606922214789025 -1.2868000000000002 0.700126195555658 0.7001251846702577 4.958530557541696e-07 -0.09607039278262641 -1.2869000000000002 0.7001282907469265 0.7001272683405826 4.984041142297446e-07 -0.09607156307571829 -1.287 0.7001303853478559 0.7001293513691844 5.00832060726375e-07 -0.09607273302726142 -1.2871000000000001 0.7001324793573067 0.7001314337575549 5.031363790874988e-07 -0.09607390263735131 -1.2872000000000001 0.7001345727741344 0.700133515507191 5.053165813978522e-07 -0.0960750719060835 -1.2873 0.7001366655971895 0.7001355966195941 5.073722078169363e-07 -0.09607624083355348 -1.2874 0.7001387578253171 0.7001376770962706 5.093028269120836e-07 -0.09607740941985665 -1.2875 0.7001408494573593 0.7001397569387302 5.111080356168252e-07 -0.09607857766508848 -1.2876 0.7001429404921533 0.7001418361484876 5.127874593419124e-07 -0.09607974556934434 -1.2877 0.7001450309285331 0.7001439147270604 5.143407520169507e-07 -0.09608091313271963 -1.2878000000000003 0.7001471207653285 0.7001459926759697 5.157675963124442e-07 -0.09608208035530966 -1.2879 0.7001492100013669 0.7001480699967398 5.170677034871396e-07 -0.09608324723720979 -1.288 0.7001512986354728 0.7001501466908975 5.182408135961936e-07 -0.09608441377851533 -1.2881000000000002 0.7001533866664683 0.7001522227599717 5.192866954911723e-07 -0.09608557997932153 -1.2882 0.7001554740931731 0.700154298205494 5.202051468616853e-07 -0.0960867458397237 -1.2883000000000002 0.7001575609144053 0.7001563730289975 5.209959942770181e-07 -0.096087911359817 -1.2884 0.700159647128981 0.7001584472320165 5.216590932277665e-07 -0.09608907653969671 -1.2885 0.7001617327357155 0.7001605208160872 5.221943281813468e-07 -0.09609024137945801 -1.2886000000000002 0.700163817733423 0.7001625937827454 5.22601612554241e-07 -0.09609140587919604 -1.2887 0.7001659021209168 0.7001646661335289 5.228808886842407e-07 -0.09609257003900595 -1.2888000000000002 0.7001679858970101 0.7001667378699745 5.230321279969807e-07 -0.0960937338589828 -1.2889000000000002 0.7001700690605162 0.7001688089936197 5.23055330770017e-07 -0.09609489733922168 -1.289 0.7001721516102487 0.700170879506001 5.229505263548706e-07 -0.0960960604798177 -1.2891000000000001 0.7001742335450214 0.700172949408655 5.227177729827392e-07 -0.09609722328086587 -1.2892000000000001 0.7001763148636495 0.7001750187031166 5.223571578755193e-07 -0.09609838574246118 -1.2893000000000001 0.700178395564949 0.7001770873909197 5.218687971209057e-07 -0.09609954786469865 -1.2894 0.7001804756477378 0.700179155473597 5.212528357695367e-07 -0.09610070964767334 -1.2895 0.7001825551108354 0.7001812229526784 5.205094475851935e-07 -0.09610187109148005 -1.2896 0.7001846339530633 0.700183289829692 5.196388351835779e-07 -0.09610303219621374 -1.2897 0.7001867121732459 0.7001853561061633 5.186412299074128e-07 -0.09610419296196933 -1.2898000000000003 0.7001887897702099 0.7001874217836156 5.175168917570527e-07 -0.09610535338884175 -1.2899 0.7001908667427854 0.7001894868635682 5.162661093904841e-07 -0.09610651347692581 -1.29 0.7001929430898053 0.7001915513475369 5.148891999429139e-07 -0.09610767322631622 -1.2901000000000002 0.7001950188101064 0.7001936152370345 5.133865090684031e-07 -0.09610883263710784 -1.2902 0.7001970939025297 0.700195678533569 5.117584107733331e-07 -0.09610999170939548 -1.2903000000000002 0.7001991683659206 0.7001977412386449 5.1000530726375e-07 -0.09611115044327384 -1.2904 0.7002012421991285 0.7001998033537611 5.081276290425096e-07 -0.0961123088388377 -1.2905 0.7002033154010079 0.7002018648804125 5.061258346733544e-07 -0.09611346689618175 -1.2906000000000002 0.7002053879704184 0.7002039258200878 5.040004105866247e-07 -0.0961146246154006 -1.2907 0.7002074599062253 0.7002059861742707 5.017518711347702e-07 -0.09611578199658898 -1.2908000000000002 0.7002095312072996 0.7002080459444391 4.993807583980603e-07 -0.09611693903984146 -1.2909000000000002 0.7002116018725179 0.7002101051320648 4.968876420596846e-07 -0.09611809574525271 -1.291 0.7002136719007637 0.7002121637386131 4.942731191975858e-07 -0.0961192521129173 -1.2911000000000001 0.7002157412909265 0.700214221765542 4.915378143122151e-07 -0.09612040814292976 -1.2912000000000001 0.7002178100419034 0.7002162792143037 4.886823789518324e-07 -0.09612156383538466 -1.2913000000000001 0.7002198781525983 0.7002183360863419 4.857074917541393e-07 -0.09612271919037645 -1.2914 0.7002219456219224 0.7002203923830935 4.82613858196479e-07 -0.09612387420799963 -1.2915 0.7002240124487951 0.7002224481059873 4.794022104293028e-07 -0.09612502888834872 -1.2916 0.7002260786321436 0.7002245032564439 4.76073307095759e-07 -0.09612618323151806 -1.2917 0.7002281441709033 0.7002265578358755 4.726279332484262e-07 -0.09612733723760213 -1.2918000000000003 0.7002302090640184 0.7002286118456857 4.6906690007175733e-07 -0.09612849090669527 -1.2919 0.7002322733104422 0.7002306652872693 4.6539104461840175e-07 -0.09612964423889192 -1.292 0.700234336909137 0.7002327181620112 4.616012297814498e-07 -0.09613079723428636 -1.2921 0.7002363998590739 0.7002347704712875 4.5769834400993803e-07 -0.09613194989297288 -1.2922 0.7002384621592348 0.7002368222164641 4.5368330111456023e-07 -0.09613310221504588 -1.2923000000000002 0.7002405238086107 0.7002388733988973 4.495570400248061e-07 -0.09613425420059958 -1.2924 0.7002425848062033 0.7002409240199321 4.4532052464324456e-07 -0.09613540584972818 -1.2925 0.7002446451510245 0.700242974080904 4.409747434777622e-07 -0.09613655716252595 -1.2926000000000002 0.700246704842097 0.7002450235831372 4.365207095721746e-07 -0.09613770813908706 -1.2927 0.7002487638784547 0.7002470725279448 4.31959460180098e-07 -0.09613885877950573 -1.2928000000000002 0.7002508222591428 0.7002491209166284 4.272920565775995e-07 -0.09614000908387604 -1.2929000000000002 0.7002528799832176 0.7002511687504781 4.225195837162521e-07 -0.09614115905229217 -1.293 0.7002549370497478 0.7002532160307724 4.176431501398681e-07 -0.09614230868484824 -1.2931000000000001 0.7002569934578133 0.7002552627587773 4.1266388753347094e-07 -0.09614345798163827 -1.2932000000000001 0.7002590492065068 0.7002573089357464 4.0758295057063965e-07 -0.09614460694275626 -1.2933000000000001 0.7002611042949335 0.7002593545629213 4.0240151668452517e-07 -0.09614575556829633 -1.2934 0.7002631587222112 0.7002613996415302 3.971207857417225e-07 -0.09614690385835245 -1.2935 0.7002652124874709 0.7002634441727887 3.917419796745092e-07 -0.09614805181301866 -1.2936 0.7002672655898563 0.7002654881578989 3.8626634237676205e-07 -0.09614919943238888 -1.2937 0.700269318028525 0.7002675315980489 3.8069513930150123e-07 -0.09615034671655699 -1.2938000000000003 0.700271369802648 0.7002695744944134 3.750296571833345e-07 -0.09615149366561694 -1.2939 0.7002734209114105 0.7002716168481534 3.692712037747792e-07 -0.09615264027966262 -1.294 0.7002754713540116 0.7002736586604156 3.6342110752013435e-07 -0.09615378655878792 -1.2941 0.7002775211296646 0.7002756999323321 3.5748071729180264e-07 -0.09615493250308663 -1.2942 0.7002795702375975 0.7002777406650202 3.5145140196701785e-07 -0.09615607811265257 -1.2943000000000002 0.7002816186770529 0.7002797808595826 3.4533455021967807e-07 -0.0961572233875795 -1.2944 0.7002836664472886 0.7002818205171073 3.391315701803399e-07 -0.09615836832796128 -1.2945 0.7002857135475773 0.7002838596386666 3.3284388909621265e-07 -0.09615951293389158 -1.2946000000000002 0.7002877599772075 0.7002858982253173 3.26472953025847e-07 -0.09616065720546414 -1.2947 0.7002898057354825 0.7002879362781007 3.2002022644361805e-07 -0.09616180114277262 -1.2948000000000002 0.700291850821722 0.7002899737980424 3.1348719197604735e-07 -0.09616294474591075 -1.2949000000000002 0.7002938952352613 0.7002920107861517 3.068753500548582e-07 -0.09616408801497214 -1.295 0.7002959389754522 0.700294047243422 3.001862185145199e-07 -0.09616523095005042 -1.2951000000000001 0.7002979820416619 0.7002960831708301 2.934213323077528e-07 -0.09616637355123918 -1.2952000000000001 0.7003000244332754 0.7002981185693364 2.865822431169507e-07 -0.09616751581863202 -1.2953000000000001 0.7003020661496934 0.7003001534398843 2.796705190141746e-07 -0.0961686577523225 -1.2954 0.7003041071903333 0.7003021877834004 2.726877440864528e-07 -0.09616979935240409 -1.2955 0.7003061475546305 0.7003042216007942 2.656355181096526e-07 -0.09617094061897033 -1.2956 0.7003081872420363 0.7003062548929582 2.5851545615296345e-07 -0.09617208155211468 -1.2957 0.70031022625202 0.7003082876607668 2.513291881833801e-07 -0.09617322215193058 -1.2958000000000003 0.7003122645840687 0.7003103199050777 2.440783587534523e-07 -0.09617436241851152 -1.2959 0.7003143022376863 0.7003123516267307 2.3676462656413433e-07 -0.09617550235195084 -1.296 0.7003163392123951 0.7003143828265472 2.2938966414559614e-07 -0.09617664195234199 -1.2961 0.7003183755077352 0.7003164135053312 2.2195515742007288e-07 -0.09617778121977832 -1.2962 0.7003204111232642 0.7003184436638684 2.1446280534798134e-07 -0.09617892015435311 -1.2963000000000002 0.7003224460585585 0.7003204733029261 2.0691431953934192e-07 -0.09618005875615976 -1.2964 0.7003244803132125 0.7003225024232533 1.9931142386866996e-07 -0.09618119702529146 -1.2965 0.7003265138868391 0.7003245310255803 1.9165585406558105e-07 -0.09618233496184155 -1.2966000000000002 0.70032854677907 0.7003265591106191 1.8394935731580464e-07 -0.09618347256590323 -1.2967 0.7003305789895551 0.7003285866790625 1.761936918483198e-07 -0.09618460983756973 -1.2968000000000002 0.7003326105179632 0.7003306137315849 1.6839062660228832e-07 -0.0961857467769342 -1.2969000000000002 0.7003346413639827 0.7003326402688415 1.6054194074480166e-07 -0.09618688338408991 -1.297 0.7003366715273199 0.7003346662914683 1.5264942331699727e-07 -0.09618801965912996 -1.2971000000000001 0.700338701007701 0.7003366918000822 1.4471487280037776e-07 -0.09618915560214744 -1.2972000000000001 0.7003407298048709 0.7003387167952809 1.3674009671435505e-07 -0.0961902912132355 -1.2973000000000001 0.7003427579185943 0.7003407412776425 1.287269112033862e-07 -0.09619142649248719 -1.2974 0.7003447853486549 0.7003427652477257 1.2067714062410917e-07 -0.09619256143999554 -1.2975 0.7003468120948555 0.7003447887060699 1.1259261715329538e-07 -0.09619369605585357 -1.2976 0.7003488381570192 0.7003468116531946 1.0447518031253544e-07 -0.0961948303401543 -1.2977 0.7003508635349885 0.7003488340895998 9.632667662476391e-08 -0.09619596429299077 -1.2978000000000003 0.7003528882286252 0.7003508560157654 8.814895912159781e-08 -0.09619709791445584 -1.2979 0.7003549122378117 0.7003528774321519 7.994388697904475e-08 -0.0961982312046425 -1.298 0.7003569355624488 0.7003548983391995 7.171332507341366e-08 -0.09619936416364366 -1.2981 0.7003589582024583 0.700356918737329 6.345914355110338e-08 -0.0962004967915522 -1.2982 0.7003609801577816 0.7003589386269404 5.5183217400125995e-08 -0.09620162908846094 -1.2983000000000002 0.7003630014283798 0.7003609580084142 4.6887426045916225e-08 -0.09620276105446272 -1.2984 0.7003650220142346 0.7003629768821114 3.857365290724224e-08 -0.09620389268965045 -1.2985 0.7003670419153473 0.7003649952483713 3.024378498507618e-08 -0.09620502399411683 -1.2986000000000002 0.7003690611317389 0.700367013107514 2.189971240983135e-08 -0.09620615496795462 -1.2987 0.7003710796634515 0.7003690304598398 1.3543328033702173e-08 -0.0962072856112566 -1.2988000000000002 0.7003730975105462 0.7003710473056277 5.176526992646535e-09 -0.09620841592411548 -1.2989000000000002 0.7003751146731051 0.7003730636451377 -3.1987937246930054e-09 -0.09620954590662391 -1.299 0.7003771311512301 0.7003750794786084 -1.15807356967923e-08 -0.09621067555887464 -1.2991000000000001 0.7003791469450436 0.7003770948062593 -1.9967399517671625e-08 -0.0962118048809603 -1.2992000000000001 0.7003811620546874 0.7003791096282882 -2.835688520759147e-08 -0.09621293387297344 -1.2993000000000001 0.7003831764803243 0.7003811239448741 -3.674729265605754e-08 -0.09621406253500676 -1.2994 0.700385190222137 0.7003831377561747 -4.513672204899642e-08 -0.0962151908671528 -1.2995 0.7003872032803278 0.700385151062328 -5.3523274294413337e-08 -0.09621631886950409 -1.2996 0.7003892156551202 0.7003871638634516 -6.190505145780775e-08 -0.09621744654215318 -1.2997 0.700391227346757 0.7003891761596429 -7.02801571913006e-08 -0.09621857388519256 -1.2998000000000003 0.7003932383555014 0.700391187950979 -7.864669715777414e-08 -0.09621970089871475 -1.2999 0.7003952486816365 0.7003931992375168 -8.700277946433604e-08 -0.09622082758281215 -1.3 0.700397258325466 0.7003952100192931 -9.534651508602554e-08 -0.09622195393757721 -1.3001 0.7003992672873129 0.7003972202963247 -1.0367601829732592e-07 -0.09622307996310236 -1.3002 0.700401275567521 0.7003992300686083 -1.119894070967381e-07 -0.09622420565948002 -1.3003000000000002 0.7004032831664531 0.7004012393361205 -1.2028480362961946e-07 -0.09622533102680249 -1.3004 0.7004052900844925 0.700403248098818 -1.2856033461232375e-07 -0.09622645606516216 -1.3005 0.7004072963220422 0.7004052563566375 -1.3681413175634094e-07 -0.0962275807746513 -1.3006000000000002 0.700409301879525 0.7004072641094959 -1.4504433219937607e-07 -0.09622870515536225 -1.3007 0.7004113067573832 0.70040927135729 -1.5324907889913142e-07 -0.09622982920738718 -1.3008000000000002 0.7004133109560791 0.7004112780998972 -1.614265210878041e-07 -0.09623095293081846 -1.3009000000000002 0.7004153144760942 0.7004132843371753 -1.6957481466239877e-07 -0.09623207632574823 -1.301 0.7004173173179298 0.7004152900689627 -1.7769212260626555e-07 -0.09623319939226878 -1.3011000000000001 0.7004193194821066 0.7004172952950776 -1.8577661540369883e-07 -0.09623432213047221 -1.3012000000000001 0.7004213209691641 0.7004193000153189 -1.9382647149096544e-07 -0.09623544454045065 -1.3013000000000001 0.7004233217796618 0.700421304229467 -2.0183987758590205e-07 -0.0962365666222963 -1.3014000000000001 0.7004253219141781 0.7004233079372822 -2.0981502916322947e-07 -0.09623768837610125 -1.3015 0.7004273213733101 0.7004253111385057 -2.1775013083272232e-07 -0.09623880980195751 -1.3016 0.7004293201576743 0.7004273138328603 -2.2564339675207323e-07 -0.09623993089995722 -1.3017 0.700431318267906 0.700429316020049 -2.3349305103281814e-07 -0.09624105167019238 -1.3018000000000003 0.7004333157046587 0.7004313176997566 -2.4129732812891436e-07 -0.09624217211275499 -1.3019 0.7004353124686051 0.7004333188716494 -2.490544732253186e-07 -0.09624329222773705 -1.302 0.7004373085604363 0.7004353195353741 -2.56762742664729e-07 -0.09624441201523051 -1.3021 0.7004393039808617 0.7004373196905597 -2.644204043153464e-07 -0.09624553147532729 -1.3022 0.700441298730609 0.7004393193368169 -2.720257379733304e-07 -0.09624665060811936 -1.3023000000000002 0.7004432928104241 0.700441318473738 -2.795770357166827e-07 -0.09624776941369861 -1.3024 0.7004452862210703 0.700443317100897 -2.8707260235280585e-07 -0.09624888789215685 -1.3025 0.7004472789633296 0.7004453152178505 -2.9451075570646745e-07 -0.09625000604358601 -1.3026000000000002 0.7004492710380011 0.7004473128241366 -3.0188982710205314e-07 -0.09625112386807781 -1.3027 0.7004512624459021 0.7004493099192766 -3.0920816165846965e-07 -0.09625224136572418 -1.3028000000000002 0.7004532531878661 0.7004513065027733 -3.1646411869507007e-07 -0.09625335853661675 -1.3029000000000002 0.7004552432647451 0.7004533025741131 -3.236560720959458e-07 -0.09625447538084732 -1.303 0.7004572326774077 0.7004552981327647 -3.307824106846269e-07 -0.09625559189850769 -1.3031000000000001 0.7004592214267392 0.7004572931781801 -3.3784153853633203e-07 -0.09625670808968945 -1.3032000000000001 0.7004612095136422 0.700459287709794 -3.448318754081803e-07 -0.09625782395448437 -1.3033000000000001 0.7004631969390354 0.7004612817270248 -3.517518570236855e-07 -0.09625893949298406 -1.3034000000000001 0.7004651837038539 0.7004632752292743 -3.585999354613345e-07 -0.09626005470528015 -1.3035 0.7004671698090494 0.700465268215928 -3.653745795223484e-07 -0.09626116959146427 -1.3036 0.7004691552555897 0.700467260686355 -3.720742750082384e-07 -0.09626228415162805 -1.3037 0.7004711400444579 0.700469252639909 -3.786975251232616e-07 -0.09626339838586298 -1.3038000000000003 0.7004731241766535 0.7004712440759274 -3.852428507589156e-07 -0.09626451229426068 -1.3039 0.7004751076531905 0.7004732349937322 -3.9170879089639454e-07 -0.09626562587691254 -1.304 0.7004770904750994 0.7004752253926296 -3.9809390282863344e-07 -0.09626673913391011 -1.3041 0.7004790726434251 0.7004772152719119 -4.0439676255582535e-07 -0.09626785206534495 -1.3042 0.7004810541592272 0.7004792046308548 -4.106159650837937e-07 -0.09626896467130838 -1.3043000000000002 0.7004830350235806 0.7004811934687205 -4.167501247570593e-07 -0.09627007695189191 -1.3044 0.7004850152375742 0.7004831817847559 -4.2279787551557924e-07 -0.09627118890718689 -1.3045 0.7004869948023114 0.7004851695781936 -4.287578712625084e-07 -0.09627230053728471 -1.3046000000000002 0.7004889737189095 0.7004871568482525 -4.346287860862441e-07 -0.09627341184227674 -1.3047 0.7004909519884996 0.7004891435941372 -4.404093146559429e-07 -0.0962745228222543 -1.3048000000000002 0.7004929296122266 0.7004911298150382 -4.460981724435653e-07 -0.09627563347730861 -1.3049000000000002 0.7004949065912487 0.7004931155101338 -4.516940960083704e-07 -0.09627674380753108 -1.305 0.7004968829267375 0.7004951006785878 -4.571958433022272e-07 -0.09627785381301292 -1.3051000000000001 0.7004988586198768 0.7004970853195516 -4.6260219396104807e-07 -0.09627896349384533 -1.3052000000000001 0.700500833671864 0.7004990694321638 -4.679119495060169e-07 -0.09628007285011958 -1.3053000000000001 0.7005028080839082 0.7005010530155499 -4.731239336905335e-07 -0.0962811818819268 -1.3054000000000001 0.7005047818572312 0.7005030360688238 -4.782369926945029e-07 -0.0962822905893582 -1.3055 0.7005067549930666 0.7005050185910875 -4.83249995464341e-07 -0.09628339897250493 -1.3056 0.7005087274926596 0.7005070005814298 -4.881618338309357e-07 -0.09628450703145802 -1.3057 0.7005106993572672 0.7005089820389296 -4.929714228912863e-07 -0.09628561476630865 -1.3058 0.7005126705881572 0.7005109629626536 -4.976777011750366e-07 -0.09628672217714788 -1.3059 0.700514641186609 0.7005129433516576 -5.022796308942756e-07 -0.09628782926406675 -1.306 0.7005166111539118 0.7005149232049867 -5.067761981794594e-07 -0.09628893602715628 -1.3061 0.7005185804913666 0.7005169025216749 -5.111664132390059e-07 -0.09629004246650752 -1.3062 0.7005205492002831 0.7005188813007466 -5.154493107270564e-07 -0.09629114858221134 -1.3063000000000002 0.7005225172819821 0.7005208595412156 -5.196239497851085e-07 -0.09629225437435877 -1.3064 0.7005244847377936 0.7005228372420866 -5.236894143403892e-07 -0.09629335984304077 -1.3065 0.700526451569057 0.7005248144023544 -5.276448133625933e-07 -0.0962944649883482 -1.3066000000000002 0.7005284177771209 0.7005267910210042 -5.314892808708227e-07 -0.09629556981037193 -1.3067 0.7005303833633427 0.7005287670970126 -5.352219763291033e-07 -0.0962966743092028 -1.3068000000000002 0.7005323483290888 0.7005307426293477 -5.388420847088349e-07 -0.09629777848493175 -1.3069000000000002 0.7005343126757337 0.7005327176169689 -5.423488166900192e-07 -0.09629888233764954 -1.307 0.7005362764046597 0.7005346920588273 -5.457414088971824e-07 -0.09629998586744692 -1.3071000000000002 0.700538239517257 0.7005366659538669 -5.490191239063136e-07 -0.09630108907441476 -1.3072000000000001 0.7005402020149236 0.7005386393010231 -5.521812506403823e-07 -0.0963021919586437 -1.3073000000000001 0.7005421638990643 0.7005406120992244 -5.552271043207657e-07 -0.09630329452022447 -1.3074000000000001 0.7005441251710911 0.7005425843473925 -5.581560266892938e-07 -0.09630439675924783 -1.3075 0.7005460858324226 0.7005445560444419 -5.609673861539655e-07 -0.09630549867580437 -1.3076 0.7005480458844842 0.7005465271892812 -5.63660577934666e-07 -0.09630660026998486 -1.3077 0.7005500053287064 0.7005484977808127 -5.662350241603109e-07 -0.09630770154187984 -1.3078 0.7005519641665263 0.7005504678179322 -5.686901739798689e-07 -0.09630880249157993 -1.3079 0.7005539223993862 0.7005524372995305 -5.710255038537948e-07 -0.09630990311917574 -1.308 0.7005558800287337 0.7005544062244932 -5.732405172903521e-07 -0.09631100342475779 -1.3081 0.7005578370560213 0.7005563745917003 -5.75334745400724e-07 -0.09631210340841663 -1.3082 0.7005597934827059 0.7005583424000279 -5.773077466769694e-07 -0.09631320307024278 -1.3083000000000002 0.7005617493102492 0.7005603096483466 -5.791591072140667e-07 -0.09631430241032671 -1.3084 0.7005637045401165 0.7005622763355239 -5.808884407654258e-07 -0.09631540142875891 -1.3085 0.7005656591737774 0.7005642424604228 -5.824953888400319e-07 -0.09631650012562983 -1.3086000000000002 0.7005676132127044 0.7005662080219033 -5.839796207579573e-07 -0.09631759850102986 -1.3087 0.7005695666583733 0.7005681730188211 -5.853408337197497e-07 -0.09631869655504936 -1.3088000000000002 0.700571519512263 0.7005701374500304 -5.865787528480659e-07 -0.09631979428777877 -1.3089000000000002 0.7005734717758545 0.700572101314382 -5.876931313680833e-07 -0.09632089169930841 -1.309 0.7005754234506314 0.7005740646107241 -5.886837504409659e-07 -0.09632198878972865 -1.3091000000000002 0.7005773745380792 0.7005760273379036 -5.895504193581536e-07 -0.09632308555912975 -1.3092000000000001 0.7005793250396852 0.7005779894947646 -5.902929755691178e-07 -0.09632418200760197 -1.3093000000000001 0.700581274956938 0.7005799510801507 -5.909112846813613e-07 -0.09632527813523561 -1.3094000000000001 0.7005832242913266 0.7005819120929041 -5.914052404465409e-07 -0.09632637394212087 -1.3095 0.7005851730443418 0.7005838725318657 -5.917747648437333e-07 -0.09632746942834797 -1.3096 0.7005871212174744 0.7005858323958767 -5.920198080794359e-07 -0.09632856459400711 -1.3097 0.7005890688122149 0.7005877916837769 -5.921403485459331e-07 -0.0963296594391884 -1.3098 0.7005910158300548 0.7005897503944074 -5.92136392779663e-07 -0.09633075396398208 -1.3099 0.7005929622724842 0.7005917085266087 -5.92007975613873e-07 -0.09633184816847822 -1.31 0.7005949081409923 0.7005936660792225 -5.917551601231086e-07 -0.09633294205276685 -1.3101 0.7005968534370683 0.7005956230510911 -5.913780374150468e-07 -0.09633403561693814 -1.3102 0.7005987981621993 0.7005975794410582 -5.908767267692738e-07 -0.09633512886108206 -1.3103000000000002 0.7006007423178705 0.7005995352479691 -5.902513755956518e-07 -0.09633622178528865 -1.3104 0.7006026859055661 0.7006014904706709 -5.895021593371741e-07 -0.09633731438964795 -1.3105 0.7006046289267673 0.7006034451080128 -5.886292815671101e-07 -0.09633840667424991 -1.3106000000000002 0.7006065713829532 0.7006053991588467 -5.876329736420605e-07 -0.0963394986391845 -1.3107 0.7006085132755997 0.7006073526220267 -5.865134949101236e-07 -0.09634059028454164 -1.3108000000000002 0.7006104546061799 0.7006093054964104 -5.852711325304849e-07 -0.09634168161041126 -1.3109000000000002 0.7006123953761632 0.7006112577808585 -5.839062014734164e-07 -0.0963427726168832 -1.311 0.7006143355870155 0.7006132094742358 -5.824190443398658e-07 -0.09634386330404737 -1.3111000000000002 0.7006162752401983 0.7006151605754103 -5.808100313475784e-07 -0.09634495367199357 -1.3112000000000001 0.7006182143371699 0.7006171110832545 -5.790795603033416e-07 -0.09634604372081167 -1.3113000000000001 0.7006201528793824 0.7006190609966458 -5.772280562976739e-07 -0.09634713345059143 -1.3114000000000001 0.7006220908682841 0.7006210103144659 -5.752559717742134e-07 -0.09634822286142258 -1.3115 0.700624028305318 0.7006229590356017 -5.731637864048178e-07 -0.09634931195339494 -1.3116 0.7006259651919213 0.7006249071589453 -5.709520068813978e-07 -0.09635040072659817 -1.3117 0.7006279015295258 0.7006268546833951 -5.686211669159169e-07 -0.09635148918112202 -1.3118 0.700629837319557 0.7006288016078547 -5.66171827073858e-07 -0.09635257731705614 -1.3119 0.7006317725634343 0.7006307479312344 -5.636045745244234e-07 -0.09635366513449022 -1.312 0.7006337072625702 0.7006326936524507 -5.609200230960454e-07 -0.09635475263351381 -1.3121 0.7006356414183706 0.7006346387704276 -5.581188129849535e-07 -0.09635583981421662 -1.3122 0.7006375750322342 0.7006365832840951 -5.552016106163959e-07 -0.09635692667668816 -1.3123000000000002 0.7006395081055523 0.7006385271923907 -5.521691085891289e-07 -0.096358013221018 -1.3124 0.7006414406397081 0.7006404704942609 -5.490220253562272e-07 -0.09635909944729573 -1.3125 0.7006433726360772 0.7006424131886585 -5.457611052250844e-07 -0.0963601853556108 -1.3126000000000002 0.700645304096027 0.7006443552745453 -5.423871180451623e-07 -0.09636127094605275 -1.3127 0.7006472350209159 0.7006462967508912 -5.38900859103908e-07 -0.09636235621871103 -1.3128000000000002 0.7006491654120941 0.700648237616675 -5.353031488769533e-07 -0.09636344117367511 -1.3129000000000002 0.7006510952709023 0.7006501778708845 -5.315948329240316e-07 -0.0963645258110344 -1.313 0.7006530245986722 0.7006521175125165 -5.27776781611422e-07 -0.0963656101308783 -1.3131000000000002 0.7006549533967252 0.7006540565405777 -5.23849889931538e-07 -0.09636669413329615 -1.3132000000000001 0.7006568816663739 0.700655994954084 -5.198150773502719e-07 -0.09636777781837737 -1.3133000000000001 0.7006588094089199 0.700657932752062 -5.156732874808667e-07 -0.09636886118621125 -1.3134000000000001 0.7006607366256552 0.700659869933548 -5.11425487917383e-07 -0.09636994423688716 -1.3135 0.7006626633178603 0.7006618064975894 -5.070726700820427e-07 -0.09637102697049432 -1.3136 0.7006645894868055 0.7006637424432436 -5.026158488227739e-07 -0.09637210938712198 -1.3137 0.7006665151337498 0.7006656777695797 -4.980560624132102e-07 -0.09637319148685945 -1.3138 0.7006684402599406 0.7006676124756777 -4.933943720808465e-07 -0.09637427326979586 -1.3139 0.7006703648666139 0.7006695465606295 -4.886318619445884e-07 -0.09637535473602046 -1.314 0.700672288954994 0.7006714800235384 -4.83769638605358e-07 -0.09637643588562239 -1.3141 0.7006742125262931 0.7006734128635198 -4.788088309864991e-07 -0.09637751671869084 -1.3142 0.7006761355817108 0.7006753450797014 -4.7375059006316e-07 -0.09637859723531489 -1.3143000000000002 0.7006780581224342 0.7006772766712233 -4.685960885431051e-07 -0.09637967743558368 -1.3144 0.700679980149638 0.7006792076372381 -4.633465206793641e-07 -0.09638075731958623 -1.3145 0.7006819016644837 0.700681137976912 -4.5800310192328775e-07 -0.09638183688741174 -1.3146000000000002 0.7006838226681193 0.7006830676894233 -4.5256706869556407e-07 -0.0963829161391491 -1.3147 0.7006857431616795 0.7006849967739646 -4.4703967801151823e-07 -0.09638399507488736 -1.3148000000000002 0.7006876631462855 0.7006869252297412 -4.4142220730070125e-07 -0.09638507369471548 -1.3149000000000002 0.7006895826230446 0.7006888530559731 -4.35715954080762e-07 -0.09638615199872247 -1.315 0.7006915015930497 0.7006907802518936 -4.2992223561744147e-07 -0.09638722998699722 -1.3151000000000002 0.70069342005738 0.7006927068167506 -4.2404238863313903e-07 -0.09638830765962873 -1.3152000000000001 0.7006953380170995 0.7006946327498063 -4.1807776898772353e-07 -0.0963893850167058 -1.3153000000000001 0.7006972554732582 0.7006965580503373 -4.1202975145648857e-07 -0.09639046205831736 -1.3154000000000001 0.7006991724268905 0.7006984827176354 -4.058997293138189e-07 -0.09639153878455228 -1.3155 0.7007010888790166 0.7007004067510068 -3.996891140209402e-07 -0.09639261519549931 -1.3156 0.7007030048306404 0.7007023301497737 -3.933993349761189e-07 -0.09639369129124732 -1.3157 0.700704920282751 0.7007042529132731 -3.870318391191452e-07 -0.09639476707188507 -1.3158 0.7007068352363217 0.7007061750408576 -3.805880905566328e-07 -0.0963958425375013 -1.3159 0.7007087496923099 0.7007080965318957 -3.7406957035385213e-07 -0.09639691768818473 -1.316 0.7007106636516571 0.7007100173857721 -3.674777761183967e-07 -0.09639799252402417 -1.3161 0.7007125771152889 0.7007119376018869 -3.608142216324217e-07 -0.09639906704510821 -1.3162 0.7007144900841136 0.7007138571796566 -3.540804365403938e-07 -0.09640014125152555 -1.3163000000000002 0.700716402559024 0.7007157761185148 -3.472779660368408e-07 -0.0964012151433648 -1.3164 0.700718314540896 0.7007176944179107 -3.404083703875682e-07 -0.09640228872071463 -1.3165 0.7007202260305885 0.7007196120773111 -3.334732247284311e-07 -0.09640336198366366 -1.3166000000000002 0.7007221370289431 0.7007215290961994 -3.264741185934894e-07 -0.09640443493230041 -1.3167 0.700724047536785 0.7007234454740756 -3.1941265560969656e-07 -0.0964055075667134 -1.3168000000000002 0.7007259575549216 0.7007253612104576 -3.122904530805659e-07 -0.09640657988699124 -1.3169000000000002 0.7007278670841431 0.70072727630488 -3.0510914164616487e-07 -0.09640765189322238 -1.317 0.7007297761252222 0.7007291907568952 -2.9787036493617025e-07 -0.09640872358549533 -1.3171000000000002 0.7007316846789136 0.7007311045660735 -2.905757791327179e-07 -0.09640979496389854 -1.3172000000000001 0.7007335927459544 0.7007330177320021 -2.8322705263733594e-07 -0.09641086602852045 -1.3173000000000001 0.7007355003270639 0.7007349302542869 -2.7582586567542755e-07 -0.09641193677944948 -1.3174000000000001 0.7007374074229429 0.7007368421325515 -2.6837390990769316e-07 -0.09641300721677402 -1.3175 0.7007393140342746 0.7007387533664369 -2.608728880415523e-07 -0.09641407734058242 -1.3176 0.7007412201617234 0.7007406639556035 -2.533245134529738e-07 -0.09641514715096304 -1.3177 0.7007431258059352 0.7007425738997293 -2.4573050983259237e-07 -0.09641621664800419 -1.3178 0.7007450309675383 0.7007444831985108 -2.38092610693047e-07 -0.0964172858317942 -1.3179 0.7007469356471414 0.700746391851663 -2.304125590532613e-07 -0.09641835470242133 -1.318 0.700748839845335 0.7007482998589197 -2.2269210702904885e-07 -0.09641942325997382 -1.3181 0.7007507435626905 0.7007502072200333 -2.1493301540984056e-07 -0.09642049150453993 -1.3182 0.7007526467997607 0.7007521139347752 -2.0713705326663723e-07 -0.0964215594362079 -1.3183000000000002 0.7007545495570794 0.7007540200029351 -1.9930599758077872e-07 -0.0964226270550658 -1.3184 0.7007564518351612 0.7007559254243223 -1.9144163279291582e-07 -0.09642369436120192 -1.3185 0.7007583536345015 0.7007578301987648 -1.8354575039708498e-07 -0.09642476135470435 -1.3186000000000002 0.7007602549555768 0.70075973432611 -1.756201486076414e-07 -0.0964258280356612 -1.3187 0.7007621557988444 0.7007616378062239 -1.67666631838842e-07 -0.09642689440416059 -1.3188000000000002 0.7007640561647415 0.7007635406389924 -1.5968701037004374e-07 -0.09642796046029056 -1.3189000000000002 0.7007659560536866 0.7007654428243202 -1.516830999206964e-07 -0.09642902620413916 -1.319 0.700767855466079 0.7007673443621318 -1.4365672120972284e-07 -0.09643009163579445 -1.3191000000000002 0.7007697544022979 0.7007692452523706 -1.3560969958949232e-07 -0.09643115675534442 -1.3192000000000002 0.7007716528627033 0.7007711454949999 -1.275438645739757e-07 -0.09643222156287702 -1.3193000000000001 0.7007735508476355 0.700773045090002 -1.194610494623105e-07 -0.09643328605848024 -1.3194000000000001 0.7007754483574153 0.7007749440373789 -1.1136309092246721e-07 -0.096434350242242 -1.3195 0.700777345392344 0.7007768423371525 -1.0325182854716008e-07 -0.09643541411425023 -1.3196 0.7007792419527028 0.700778739989364 -9.512910446006495e-08 -0.0964364776745928 -1.3197 0.7007811380387536 0.700780636994074 -8.699676289254665e-08 -0.09643754092335761 -1.3198 0.7007830336507388 0.700782533351363 -7.885664975604972e-08 -0.09643860386063251 -1.3199 0.7007849287888803 0.7007844290613311 -7.071061222836683e-08 -0.09643966648650529 -1.32 0.700786823453381 0.7007863241240979 -6.2560498342943e-08 -0.09644072880106376 -1.3201 0.7007887176444241 0.7007882185398027 -5.4408156559965226e-08 -0.09644179080439576 -1.3202 0.7007906113621722 0.7007901123086042 -4.62554353454752e-08 -0.09644285249658892 -1.3203000000000003 0.7007925046067691 0.7007920054306812 -3.8104182760402474e-08 -0.09644391387773103 -1.3204 0.7007943973783387 0.7007938979062318 -2.995624603712929e-08 -0.09644497494790984 -1.3205 0.7007962896769849 0.7007957897354739 -2.1813471161313824e-08 -0.09644603570721295 -1.3206000000000002 0.7007981815027923 0.7007976809186447 -1.3677702453713386e-08 -0.0964470961557281 -1.3207 0.7008000728558255 0.7007995714560014 -5.550782155097633e-09 -0.09644815629354289 -1.3208000000000002 0.7008019637361296 0.7008014613478203 2.565449993933988e-09 -0.09644921612074499 -1.3209000000000002 0.70080385414373 0.7008033505943975 1.0669157167984833e-08 -0.0964502756374219 -1.321 0.7008057440786328 0.7008052391960484 1.8758505875363096e-08 -0.09645133484366125 -1.3211000000000002 0.7008076335408246 0.7008071271531082 2.6831666369644958e-08 -0.09645239373955064 -1.3212000000000002 0.7008095225302722 0.7008090144659311 3.488681305299779e-08 -0.09645345232517756 -1.3213000000000001 0.700811411046923 0.7008109011348908 4.292212492200409e-08 -0.09645451060062947 -1.3214000000000001 0.7008132990907052 0.7008127871603798 5.093578593975967e-08 -0.09645556856599385 -1.3215 0.7008151866615275 0.7008146725428108 5.8925985466085073e-08 -0.09645662622135823 -1.3216 0.7008170737592798 0.700816557282615 6.689091867038977e-08 -0.09645768356680999 -1.3217 0.7008189603838326 0.7008184413802427 7.48287869358627e-08 -0.09645874060243659 -1.3218 0.7008208465350367 0.7008203248361637 8.273779824284622e-08 -0.0964597973283254 -1.3219 0.7008227322127246 0.7008222076508662 9.061616762159885e-08 -0.09646085374456376 -1.322 0.7008246174167094 0.7008240898248577 9.846211749750533e-08 -0.09646190985123909 -1.3221 0.7008265021467857 0.7008259713586641 1.0627387815598244e-07 -0.09646296564843863 -1.3222 0.7008283864027287 0.7008278522528302 1.140496880720765e-07 -0.0964640211362497 -1.3223000000000003 0.7008302701842959 0.7008297325079198 1.2178779435975673e-07 -0.09646507631475967 -1.3224 0.700832153491225 0.7008316121245144 1.294864531639628e-07 -0.09646613118405567 -1.3225 0.7008340363232357 0.7008334911032146 1.3714393002142722e-07 -0.09646718574422497 -1.3226000000000002 0.70083591868003 0.7008353694446389 1.447585002561924e-07 -0.09646823999535481 -1.3227 0.7008378005612907 0.7008372471494245 1.523284494132915e-07 -0.0964692939375324 -1.3228000000000002 0.7008396819666824 0.7008391242182261 1.5985207359528464e-07 -0.09647034757084483 -1.3229000000000002 0.7008415628958524 0.7008410006517166 1.6732767986471497e-07 -0.09647140089537926 -1.323 0.7008434433484296 0.700842876450587 1.7475358662227825e-07 -0.09647245391122287 -1.3231000000000002 0.7008453233240248 0.7008447516155456 1.8212812399193146e-07 -0.09647350661846271 -1.3232000000000002 0.7008472028222315 0.700846626147319 1.894496341851848e-07 -0.09647455901718588 -1.3233000000000001 0.7008490818426258 0.7008485000466501 1.9671647189661856e-07 -0.09647561110747942 -1.3234000000000001 0.7008509603847658 0.7008503733143003 2.0392700462654179e-07 -0.09647666288943035 -1.3235 0.7008528384481929 0.7008522459510478 2.1107961310773415e-07 -0.0964777143631257 -1.3236 0.700854716032431 0.7008541179576875 2.181726916142268e-07 -0.09647876552865245 -1.3237 0.7008565931369872 0.7008559893350311 2.2520464838804433e-07 -0.09647981638609751 -1.3238 0.7008584697613518 0.700857860083908 2.3217390588553544e-07 -0.0964808669355479 -1.3239 0.7008603459049985 0.7008597302051633 2.3907890125962616e-07 -0.09648191717709054 -1.324 0.700862221567384 0.7008615996996588 2.4591808664431447e-07 -0.09648296711081221 -1.3241 0.7008640967479493 0.7008634685682724 2.5268992948773716e-07 -0.09648401673679988 -1.3242 0.7008659714461185 0.7008653368118984 2.593929129129924e-07 -0.09648506605514034 -1.3243000000000003 0.7008678456613008 0.7008672044314471 2.6602553608590096e-07 -0.09648611506592053 -1.3244 0.7008697193928886 0.700869071427844 2.7258631453419557e-07 -0.09648716376922717 -1.3245 0.7008715926402584 0.7008709378020306 2.7907378043201536e-07 -0.09648821216514702 -1.3246000000000002 0.7008734654027724 0.7008728035549635 2.854864830093007e-07 -0.09648926025376686 -1.3247 0.7008753376797766 0.700874668687615 2.918229888085322e-07 -0.09649030803517349 -1.3248000000000002 0.7008772094706024 0.7008765332009723 2.980818820386144e-07 -0.09649135550945359 -1.3249000000000002 0.7008790807745656 0.7008783970960366 3.0426176491488155e-07 -0.09649240267669382 -1.325 0.7008809515909679 0.7008802603738249 3.103612578950199e-07 -0.09649344953698086 -1.3251000000000002 0.7008828219190963 0.7008821230353679 3.1637900006070696e-07 -0.0964944960904014 -1.3252000000000002 0.7008846917582237 0.7008839850817106 3.223136493743506e-07 -0.09649554233704202 -1.3253000000000001 0.7008865611076083 0.7008858465139123 3.281638830399114e-07 -0.09649658827698931 -1.3254000000000001 0.7008884299664948 0.7008877073330457 3.3392839770413074e-07 -0.09649763391032987 -1.3255 0.7008902983341144 0.7008895675401979 3.3960590982429206e-07 -0.09649867923715028 -1.3256000000000001 0.7008921662096844 0.7008914271364686 3.4519515593883776e-07 -0.09649972425753703 -1.3257 0.7008940335924092 0.7008932861229706 3.5069489293104716e-07 -0.09650076897157667 -1.3258 0.7008959004814801 0.7008951445008309 3.561038982788367e-07 -0.09650181337935572 -1.3259 0.700897766876075 0.7008970022711875 3.614209704294602e-07 -0.09650285748096057 -1.326 0.7008996327753602 0.700898859435192 3.666449289382867e-07 -0.09650390127647773 -1.3261 0.7009014981784888 0.7009007159940082 3.7177461482268415e-07 -0.09650494476599358 -1.3262 0.7009033630846018 0.7009025719488116 3.768088907840639e-07 -0.09650598794959453 -1.3263000000000003 0.7009052274928294 0.7009044273007897 3.8174664141604753e-07 -0.09650703082736699 -1.3264 0.7009070914022886 0.7009062820511416 3.865867735652895e-07 -0.09650807339939727 -1.3265 0.7009089548120859 0.7009081362010776 3.9132821647025473e-07 -0.09650911566577174 -1.3266000000000002 0.7009108177213166 0.7009099897518196 3.959699220387747e-07 -0.09651015762657669 -1.3267 0.7009126801290644 0.7009118427045995 4.005108650839695e-07 -0.09651119928189841 -1.3268000000000002 0.7009145420344032 0.7009136950606605 4.0495004352547603e-07 -0.09651224063182318 -1.3269000000000002 0.7009164034363958 0.700915546821256 4.0928647865312584e-07 -0.09651328167643726 -1.327 0.7009182643340952 0.7009173979876491 4.135192152587841e-07 -0.0965143224158268 -1.3271000000000002 0.7009201247265441 0.7009192485611135 4.1764732200411103e-07 -0.09651536285007808 -1.3272 0.7009219846127757 0.7009210985429318 4.2166989145525635e-07 -0.09651640297927722 -1.3273000000000001 0.7009238439918141 0.700922947934396 4.2558604036041503e-07 -0.09651744280351038 -1.3274000000000001 0.7009257028626736 0.700924796736808 4.293949098510552e-07 -0.09651848232286372 -1.3275 0.7009275612243597 0.7009266449514774 4.330956656084517e-07 -0.09651952153742331 -1.3276000000000001 0.7009294190758701 0.7009284925797233 4.3668749803715823e-07 -0.09652056044727532 -1.3277 0.7009312764161932 0.7009303396228725 4.4016962249399105e-07 -0.09652159905250575 -1.3278 0.7009331332443095 0.7009321860822599 4.43541279412929e-07 -0.09652263735320062 -1.3279 0.7009349895591918 0.7009340319592283 4.4680173444389126e-07 -0.09652367534944599 -1.328 0.700936845359805 0.7009358772551282 4.499502787164156e-07 -0.09652471304132787 -1.3281 0.7009387006451074 0.7009377219713167 4.529862288604747e-07 -0.09652575042893217 -1.3282 0.7009405554140495 0.700939566109158 4.5590892729791e-07 -0.09652678751234486 -1.3283000000000003 0.7009424096655759 0.7009414096700237 4.5871774222855377e-07 -0.09652782429165196 -1.3284 0.7009442633986237 0.700943252655291 4.614120678800293e-07 -0.09652886076693931 -1.3285 0.7009461166121246 0.7009450950663436 4.63991324632651e-07 -0.09652989693829284 -1.3286000000000002 0.7009479693050041 0.7009469369045704 4.664549591026912e-07 -0.09653093280579832 -1.3287 0.7009498214761822 0.7009487781713668 4.6880244425340223e-07 -0.09653196836954168 -1.3288000000000002 0.7009516731245732 0.7009506188681324 4.710332795476724e-07 -0.09653300362960865 -1.3289000000000002 0.7009535242490869 0.7009524589962728 4.7314699103129243e-07 -0.0965340385860851 -1.329 0.7009553748486278 0.7009542985571976 4.751431314370391e-07 -0.09653507323905679 -1.3291000000000002 0.700957224922096 0.7009561375523213 4.770212803373308e-07 -0.09653610758860945 -1.3292 0.7009590744683876 0.7009579759830622 4.787810440193274e-07 -0.09653714163482885 -1.3293000000000001 0.7009609234863948 0.7009598138508425 4.804220558735084e-07 -0.09653817537780066 -1.3294000000000001 0.7009627719750061 0.7009616511570881 4.819439762687727e-07 -0.0965392088176106 -1.3295 0.7009646199331063 0.7009634879032278 4.833464926912168e-07 -0.09654024195434432 -1.3296000000000001 0.7009664673595779 0.7009653240906938 4.846293197857676e-07 -0.09654127478808745 -1.3297 0.7009683142532998 0.7009671597209208 4.857921993423053e-07 -0.09654230731892567 -1.3298 0.7009701606131488 0.7009689947953455 4.868349005177075e-07 -0.09654333954694447 -1.3299 0.7009720064379994 0.7009708293154074 4.877572197525826e-07 -0.0965443714722295 -1.33 0.7009738517267247 0.7009726632825475 4.885589808684143e-07 -0.09654540309486624 -1.3301 0.7009756964781954 0.7009744966982079 4.892400350398063e-07 -0.09654643441494025 -1.3302 0.7009775406912817 0.7009763295638329 4.89800260849993e-07 -0.09654746543253712 -1.3303000000000003 0.7009793843648524 0.700978161880867 4.902395643741064e-07 -0.09654849614774227 -1.3304 0.7009812274977751 0.7009799936507554 4.905578790542764e-07 -0.09654952656064114 -1.3305 0.7009830700889177 0.7009818248749438 4.907551658522857e-07 -0.0965505566713192 -1.3306000000000002 0.7009849121371476 0.7009836555548778 4.908314132079372e-07 -0.09655158647986188 -1.3307 0.7009867536413326 0.700985485692003 4.907866369557867e-07 -0.09655261598635452 -1.3308000000000002 0.7009885946003404 0.7009873152877641 4.906208803251433e-07 -0.09655364519088251 -1.3309000000000002 0.7009904350130404 0.7009891443436056 4.903342141898692e-07 -0.09655467409353129 -1.331 0.700992274878302 0.70099097286097 4.899267365826576e-07 -0.09655570269438606 -1.3311000000000002 0.7009941141949967 0.7009928008412991 4.893985730280992e-07 -0.09655673099353221 -1.3312 0.7009959529619969 0.7009946282860329 4.887498763622711e-07 -0.09655775899105497 -1.3313000000000001 0.7009977911781777 0.7009964551966094 4.879808267604924e-07 -0.09655878668703967 -1.3314000000000001 0.7009996288424157 0.7009982815744641 4.870916315707907e-07 -0.09655981408157155 -1.3315 0.7010014659535903 0.7010001074210301 4.86082525397169e-07 -0.09656084117473576 -1.3316000000000001 0.7010033025105834 0.7010019327377375 4.849537699608275e-07 -0.0965618679666175 -1.3317 0.7010051385122806 0.7010037575260136 4.837056540585305e-07 -0.09656289445730204 -1.3318 0.7010069739575704 0.701005581787282 4.823384934099506e-07 -0.09656392064687448 -1.3319 0.7010088088453449 0.7010074055229626 4.808526307548133e-07 -0.09656494653541997 -1.332 0.7010106431745 0.7010092287344712 4.792484356169746e-07 -0.09656597212302358 -1.3321 0.7010124769439359 0.7010110514232195 4.775263042072764e-07 -0.09656699740977036 -1.3322 0.7010143101525577 0.7010128735906145 4.756866595345688e-07 -0.09656802239574541 -1.3323000000000003 0.7010161427992747 0.7010146952380585 4.7372995097549886e-07 -0.09656904708103382 -1.3324 0.7010179748830015 0.7010165163669486 4.716566544271661e-07 -0.09657007146572055 -1.3325 0.7010198064026583 0.7010183369786765 4.694672720850779e-07 -0.09657109554989064 -1.3326000000000002 0.70102163735717 0.7010201570746281 4.671623323737606e-07 -0.09657211933362903 -1.3327 0.7010234677454686 0.7010219766561834 4.6474238969695936e-07 -0.09657314281702067 -1.3328000000000002 0.7010252975664916 0.701023795724716 4.62208024444577e-07 -0.09657416600015052 -1.3329000000000002 0.7010271268191826 0.7010256142815932 4.5955984284695717e-07 -0.09657518888310342 -1.333 0.7010289555024927 0.7010274323281751 4.5679847673202323e-07 -0.09657621146596429 -1.3331000000000002 0.7010307836153793 0.7010292498658158 4.5392458345588915e-07 -0.09657723374881803 -1.3332 0.7010326111568077 0.7010310668958608 4.5093884570857057e-07 -0.09657825573174947 -1.3333000000000002 0.7010344381257503 0.7010328834196489 4.4784197139602355e-07 -0.0965792774148434 -1.3334000000000001 0.7010362645211874 0.7010346994385099 4.4463469337646666e-07 -0.09658029879818464 -1.3335 0.7010380903421075 0.7010365149537674 4.4131776945344203e-07 -0.09658131988185807 -1.3336000000000001 0.7010399155875071 0.7010383299667344 4.378919820149929e-07 -0.09658234066594834 -1.3337 0.7010417402563913 0.7010401444787167 4.34358137943458e-07 -0.09658336115054017 -1.3338 0.7010435643477742 0.7010419584910105 4.307170684350603e-07 -0.09658438133571828 -1.3339 0.7010453878606788 0.7010437720049032 4.2696962879174016e-07 -0.09658540122156735 -1.334 0.7010472107941379 0.7010455850216724 4.231166981713552e-07 -0.09658642080817209 -1.3341 0.7010490331471935 0.7010473975425864 4.1915917947665804e-07 -0.0965874400956171 -1.3342 0.7010508549188972 0.7010492095689035 4.1509799907080147e-07 -0.09658845908398699 -1.3343000000000003 0.7010526761083109 0.7010510211018716 4.1093410654835516e-07 -0.09658947777336634 -1.3344 0.7010544967145075 0.7010528321427283 4.0666847461040545e-07 -0.09659049616383977 -1.3345 0.7010563167365695 0.7010546426927005 4.023020987245496e-07 -0.09659151425549183 -1.3346000000000002 0.7010581361735913 0.7010564527530043 3.978359969930567e-07 -0.09659253204840706 -1.3347 0.7010599550246772 0.7010582623248448 3.9327120980592323e-07 -0.09659354954266999 -1.3348000000000002 0.7010617732889433 0.7010600714094153 3.8860879968127815e-07 -0.09659456673836508 -1.3349000000000002 0.7010635909655175 0.7010618800078978 3.8384985106415526e-07 -0.09659558363557683 -1.335 0.7010654080535393 0.7010636881214625 3.7899546988934274e-07 -0.09659660023438969 -1.3351000000000002 0.7010672245521599 0.7010654957512672 3.7404678353281096e-07 -0.09659761653488805 -1.3352 0.7010690404605429 0.7010673028984576 3.690049403884399e-07 -0.09659863253715634 -1.3353000000000002 0.7010708557778644 0.701069109564167 3.638711097569969e-07 -0.09659964824127892 -1.3354000000000001 0.7010726705033128 0.7010709157495152 3.5864648142980293e-07 -0.09660066364734005 -1.3355 0.7010744846360899 0.7010727214556103 3.5333226548056595e-07 -0.09660167875542419 -1.3356000000000001 0.7010762981754104 0.7010745266835468 3.4792969200170276e-07 -0.09660269356561565 -1.3357 0.7010781111205022 0.7010763314344052 3.4244001081290554e-07 -0.09660370807799869 -1.3358 0.7010799234706067 0.701078135709253 3.3686449112807493e-07 -0.09660472229265758 -1.3359 0.7010817352249789 0.7010799395091443 3.3120442129858096e-07 -0.0966057362096766 -1.336 0.7010835463828877 0.7010817428351177 3.2546110851489063e-07 -0.09660674982913986 -1.3361 0.7010853569436164 0.701083545688199 3.1963587846656205e-07 -0.09660776315113162 -1.3362 0.7010871669064626 0.7010853480693997 3.137300751340777e-07 -0.09660877617573616 -1.3363000000000003 0.701088976270738 0.701087149979716 3.0774506033781623e-07 -0.09660978890303754 -1.3364 0.7010907850357692 0.7010889514201297 3.016822135923358e-07 -0.09661080133311997 -1.3365 0.7010925932008976 0.7010907523916072 2.955429316137126e-07 -0.09661181346606747 -1.3366000000000002 0.7010944007654794 0.7010925528951009 2.893286281183127e-07 -0.0966128253019642 -1.3367 0.7010962077288867 0.7010943529315466 2.830407334758478e-07 -0.09661383684089422 -1.3368000000000002 0.7010980140905063 0.7010961525018657 2.7668069434855225e-07 -0.09661484808294164 -1.3369000000000002 0.7010998198497406 0.7010979516069631 2.702499733789332e-07 -0.09661585902819037 -1.337 0.7011016250060081 0.7010997502477283 2.637500488567035e-07 -0.09661686967672446 -1.3371000000000002 0.7011034295587433 0.7011015484250349 2.571824143648982e-07 -0.09661788002862792 -1.3372 0.701105233507396 0.7011033461397402 2.505485784259909e-07 -0.0966188900839847 -1.3373000000000002 0.7011070368514326 0.7011051433926855 2.4385006422433797e-07 -0.09661989984287872 -1.3374000000000001 0.7011088395903361 0.7011069401846952 2.370884091759673e-07 -0.09662090930539391 -1.3375 0.7011106417236057 0.7011087365165777 2.3026516460938895e-07 -0.09662191847161421 -1.3376000000000001 0.7011124432507573 0.701110532389124 2.233818954186506e-07 -0.09662292734162338 -1.3377000000000001 0.7011142441713236 0.7011123278031087 2.1644017967475948e-07 -0.09662393591550539 -1.3378 0.7011160444848541 0.7011141227592896 2.0944160830649317e-07 -0.09662494419334398 -1.3379 0.7011178441909157 0.7011159172584068 2.0238778469100493e-07 -0.09662595217522303 -1.338 0.7011196432890923 0.7011177113011837 1.9528032433116516e-07 -0.09662695986122632 -1.3381 0.7011214417789844 0.7011195048883256 1.8812085443228876e-07 -0.09662796725143759 -1.3382 0.7011232396602112 0.7011212980205213 1.8091101360723227e-07 -0.09662897434594059 -1.3383000000000003 0.7011250369324086 0.7011230906984409 1.7365245141842678e-07 -0.09662998114481906 -1.3384 0.7011268335952303 0.7011248829227373 1.6634682805174994e-07 -0.09663098764815664 -1.3385 0.7011286296483481 0.7011266746940458 1.5899581393488682e-07 -0.09663199385603712 -1.3386000000000002 0.7011304250914511 0.7011284660129828 1.516010893105879e-07 -0.09663299976854399 -1.3387 0.7011322199242467 0.7011302568801481 1.4416434391054112e-07 -0.096634005385761 -1.3388000000000002 0.7011340141464604 0.701132047296122 1.3668727653556867e-07 -0.09663501070777172 -1.3389000000000002 0.7011358077578358 0.7011338372614673 1.2917159469480466e-07 -0.0966360157346598 -1.339 0.7011376007581347 0.7011356267767286 1.2161901416507526e-07 -0.0966370204665088 -1.3391000000000002 0.7011393931471372 0.7011374158424314 1.1403125865783181e-07 -0.09663802490340219 -1.3392 0.701141184924642 0.7011392044590832 1.0641005939240888e-07 -0.09663902904542356 -1.3393000000000002 0.7011429760904658 0.7011409926271729 9.87571547247934e-08 -0.09664003289265638 -1.3394000000000001 0.7011447666444446 0.7011427803471706 9.107428970353548e-08 -0.09664103644518417 -1.3395 0.7011465565864323 0.7011445676195276 8.336321575749817e-08 -0.09664203970309032 -1.3396000000000001 0.7011483459163019 0.7011463544446769 7.562569017544041e-08 -0.0966430426664583 -1.3397000000000001 0.701150134633945 0.7011481408230322 6.786347583019603e-08 -0.09664404533537155 -1.3398 0.7011519227392723 0.7011499267549888 6.007834068427753e-08 -0.09664504770991347 -1.3399 0.7011537102322128 0.7011517122409224 5.2272057442931397e-08 -0.09664604979016739 -1.34 0.701155497112715 0.7011534972811904 4.444640313433501e-08 -0.0966470515762167 -1.3401 0.7011572833807456 0.7011552818761304 3.660315868979358e-08 -0.09664805306814468 -1.3402 0.7011590690362908 0.701157066026062 2.874410855863152e-08 -0.09664905426603468 -1.3403000000000003 0.7011608540793559 0.7011588497312851 2.0871040298797716e-08 -0.09665005516996997 -1.3404 0.7011626385099647 0.7011606329920801 1.2985744150990908e-08 -0.09665105578003377 -1.3405 0.7011644223281606 0.7011624158087089 5.090012667428867e-09 -0.09665205609630942 -1.3406000000000002 0.7011662055340059 0.7011641981814142 -2.8143597270366416e-09 -0.09665305611888006 -1.3407 0.7011679881275819 0.7011659801104191 -1.0725577127834729e-08 -0.0966540558478289 -1.3408000000000002 0.7011697701089892 0.701167761595928 -1.8641842562672206e-08 -0.09665505528323917 -1.3409 0.7011715514783469 0.7011695426381255 -2.6561358396157836e-08 -0.09665605442519394 -1.341 0.7011733322357938 0.7011713232371777 -3.448232674722017e-08 -0.09665705327377637 -1.3411000000000002 0.7011751123814882 0.7011731033932312 -4.240294988386555e-08 -0.09665805182906964 -1.3412 0.7011768919156065 0.7011748831064133 -5.032143064070439e-08 -0.09665905009115677 -1.3413000000000002 0.7011786708383447 0.7011766623768322 -5.823597282314172e-08 -0.09666004806012084 -1.3414000000000001 0.7011804491499183 0.701178441204577 -6.614478161460352e-08 -0.0966610457360449 -1.3415 0.7011822268505608 0.7011802195897173 -7.404606398603991e-08 -0.09666204311901191 -1.3416000000000001 0.7011840039405255 0.7011819975323046 -8.193802909697151e-08 -0.09666304020910499 -1.3417000000000001 0.7011857804200848 0.7011837750323702 -8.98188887077031e-08 -0.09666403700640708 -1.3418 0.7011875562895298 0.7011855520899266 -9.76868575796111e-08 -0.0966650335110011 -1.3419 0.7011893315491704 0.7011873287049676 -1.0554015388453825e-07 -0.09666602972297 -1.342 0.7011911061993357 0.7011891048774679 -1.1337699960117797e-07 -0.09666702564239672 -1.3421 0.7011928802403733 0.7011908806073829 -1.2119562092099967e-07 -0.09666802126936412 -1.3422 0.7011946536726501 0.7011926558946497 -1.2899424865243925e-07 -0.09666901660395506 -1.3423000000000003 0.7011964264965516 0.7011944307391864 -1.3677111862855917e-07 -0.09667001164625247 -1.3424 0.7011981987124815 0.701196205140892 -1.4452447207047303e-07 -0.09667100639633912 -1.3425 0.7011999703208623 0.7011979790996472 -1.522525560366389e-07 -0.09667200085429778 -1.3426000000000002 0.7012017413221356 0.7011997526153139 -1.5995362379062072e-07 -0.09667299502021129 -1.3427 0.7012035117167613 0.7012015256877351 -1.6762593517752333e-07 -0.09667398889416243 -1.3428000000000002 0.7012052815052173 0.7012032983167359 -1.7526775706114273e-07 -0.09667498247623388 -1.3429 0.7012070506880003 0.7012050705021226 -1.828773636795844e-07 -0.09667597576650844 -1.343 0.7012088192656248 0.7012068422436832 -1.9045303705639283e-07 -0.09667696876506876 -1.3431000000000002 0.7012105872386237 0.7012086135411875 -1.9799306738219058e-07 -0.09667796147199748 -1.3432 0.7012123546075484 0.7012103843943871 -2.0549575337550086e-07 -0.09667895388737735 -1.3433000000000002 0.7012141213729675 0.7012121548030158 -2.1295940272336722e-07 -0.09667994601129093 -1.3434000000000001 0.7012158875354677 0.701213924766789 -2.2038233239707328e-07 -0.09668093784382087 -1.3435 0.701217653095654 0.7012156942854044 -2.277628690823541e-07 -0.09668192938504971 -1.3436000000000001 0.7012194180541487 0.7012174633585421 -2.3509934955062706e-07 -0.09668292063506007 -1.3437000000000001 0.7012211824115914 0.7012192319858643 -2.423901209920587e-07 -0.0966839115939345 -1.3438 0.7012229461686394 0.7012210001670163 -2.4963354143536787e-07 -0.09668490226175547 -1.3439 0.7012247093259676 0.7012227679016249 -2.568279800878315e-07 -0.09668589263860551 -1.344 0.7012264718842675 0.7012245351893005 -2.6397181773080147e-07 -0.0966868827245671 -1.3441 0.7012282338442481 0.7012263020296362 -2.710634470493023e-07 -0.09668787251972273 -1.3442 0.7012299952066355 0.7012280684222081 -2.781012730171395e-07 -0.09668886202415483 -1.3443000000000003 0.7012317559721722 0.7012298343665748 -2.8508371324037496e-07 -0.09668985123794582 -1.3444 0.7012335161416173 0.7012315998622791 -2.9200919834937444e-07 -0.09669084016117807 -1.3445 0.7012352757157467 0.7012333649088465 -2.988761723249356e-07 -0.09669182879393397 -1.3446000000000002 0.7012370346953529 0.7012351295057861 -3.056830927966603e-07 -0.09669281713629588 -1.3447 0.7012387930812441 0.7012368936525915 -3.124284315009218e-07 -0.09669380518834614 -1.3448000000000002 0.7012405508742448 0.7012386573487388 -3.191106745306649e-07 -0.09669479295016703 -1.3449 0.701242308075195 0.7012404205936889 -3.257283227239838e-07 -0.0966957804218408 -1.345 0.7012440646849518 0.701242183386887 -3.322798919833114e-07 -0.09669676760344983 -1.3451000000000002 0.7012458207043866 0.7012439457277624 -3.3876391360154745e-07 -0.09669775449507628 -1.3452 0.7012475761343863 0.7012457076157287 -3.4517893459512505e-07 -0.09669874109680242 -1.3453000000000002 0.7012493309758534 0.7012474690501844 -3.515235180509557e-07 -0.09669972740871038 -1.3454000000000002 0.7012510852297058 0.7012492300305129 -3.5779624342480165e-07 -0.09670071343088245 -1.3455 0.7012528388968756 0.7012509905560824 -3.639957068396482e-07 -0.09670169916340067 -1.3456000000000001 0.7012545919783101 0.7012527506262465 -3.701205214812209e-07 -0.09670268460634726 -1.3457000000000001 0.7012563444749709 0.7012545102403436 -3.761693178269687e-07 -0.09670366975980428 -1.3458 0.7012580963878341 0.7012562693976989 -3.8214074394443687e-07 -0.09670465462385386 -1.3459 0.7012598477178897 0.7012580280976222 -3.8803346587290566e-07 -0.09670563919857808 -1.346 0.7012615984661421 0.7012597863394098 -3.9384616785237414e-07 -0.09670662348405898 -1.3461 0.7012633486336092 0.7012615441223438 -3.9957755267744366e-07 -0.09670760748037857 -1.3462 0.7012650982213222 0.7012633014456933 -4.052263418777291e-07 -0.09670859118761889 -1.3463000000000003 0.7012668472303263 0.7012650583087133 -4.107912761480703e-07 -0.09670957460586192 -1.3464 0.7012685956616791 0.7012668147106458 -4.1627111552894336e-07 -0.0967105577351896 -1.3465 0.7012703435164518 0.7012685706507196 -4.216646397048329e-07 -0.09671154057568387 -1.3466000000000002 0.7012720907957279 0.7012703261281512 -4.269706482609714e-07 -0.0967125231274267 -1.3467 0.7012738375006038 0.7012720811421442 -4.3218796106497814e-07 -0.09671350539049997 -1.3468000000000002 0.7012755836321877 0.7012738356918897 -4.373154183431871e-07 -0.09671448736498554 -1.3469 0.7012773291916001 0.7012755897765667 -4.423518810275917e-07 -0.09671546905096527 -1.347 0.7012790741799735 0.7012773433953421 -4.472962310819728e-07 -0.096716450448521 -1.3471000000000002 0.701280818598452 0.7012790965473717 -4.521473716476154e-07 -0.09671743155773456 -1.3472 0.7012825624481911 0.7012808492317992 -4.569042272861701e-07 -0.09671841237868774 -1.3473000000000002 0.701284305730357 0.7012826014477576 -4.615657442988419e-07 -0.09671939291146231 -1.3474000000000002 0.7012860484461274 0.7012843531943681 -4.661308909137407e-07 -0.09672037315613999 -1.3475 0.7012877905966907 0.7012861044707419 -4.705986574524146e-07 -0.09672135311280255 -1.3476000000000001 0.7012895321832451 0.7012878552759794 -4.749680566906722e-07 -0.09672233278153168 -1.3477000000000001 0.701291273207 0.7012896056091702 -4.792381239418497e-07 -0.09672331216240908 -1.3478 0.7012930136691738 0.7012913554693948 -4.834079174037553e-07 -0.09672429125551639 -1.3479 0.7012947535709955 0.7012931048557234 -4.874765181656082e-07 -0.09672527006093529 -1.348 0.7012964929137029 0.7012948537672162 -4.914430306590667e-07 -0.09672624857874737 -1.3481 0.7012982316985432 0.701296602202925 -4.953065826790448e-07 -0.09672722680903423 -1.3482 0.7012999699267728 0.7012983501618917 -4.990663256335126e-07 -0.09672820475187748 -1.3483000000000003 0.7013017075996568 0.7013000976431496 -5.027214347239073e-07 -0.09672918240735862 -1.3484 0.7013034447184684 0.701301844645724 -5.062711091116667e-07 -0.09673015977555921 -1.3485 0.7013051812844895 0.7013035911686314 -5.097145721125185e-07 -0.09673113685656082 -1.3486000000000002 0.7013069172990096 0.7013053372108803 -5.130510714046466e-07 -0.09673211365044486 -1.3487 0.7013086527633259 0.7013070827714716 -5.162798790911416e-07 -0.09673309015729287 -1.3488000000000002 0.7013103876787433 0.7013088278493986 -5.194002919706175e-07 -0.09673406637718623 -1.3489 0.7013121220465737 0.7013105724436473 -5.224116316066008e-07 -0.09673504231020644 -1.349 0.701313855868136 0.7013123165531966 -5.253132445079411e-07 -0.09673601795643488 -1.3491000000000002 0.7013155891447553 0.7013140601770192 -5.281045023022846e-07 -0.09673699331595297 -1.3492 0.7013173218777637 0.7013158033140809 -5.307848018054617e-07 -0.09673796838884202 -1.3493000000000002 0.701319054068499 0.7013175459633414 -5.333535651741439e-07 -0.09673894317518339 -1.3494000000000002 0.7013207857183048 0.7013192881237542 -5.358102401001319e-07 -0.09673991767505839 -1.3495 0.7013225168285306 0.701321029794268 -5.381542997826005e-07 -0.09674089188854836 -1.3496000000000001 0.7013242474005308 0.7013227709738256 -5.403852432056544e-07 -0.09674186581573457 -1.3497000000000001 0.7013259774356649 0.7013245116613643 -5.425025951522056e-07 -0.09674283945669825 -1.3498 0.7013277069352971 0.7013262518558177 -5.445059062664237e-07 -0.09674381281152064 -1.3499 0.7013294359007962 0.7013279915561139 -5.463947533035363e-07 -0.096744785880283 -1.35 0.7013311643335352 0.7013297307611771 -5.481687390118672e-07 -0.0967457586630665 -1.3501 0.7013328922348907 0.7013314694699275 -5.49827492410393e-07 -0.0967467311599523 -1.3502 0.7013346196062427 0.7013332076812818 -5.51370668726292e-07 -0.09674770337102157 -1.3503000000000003 0.7013363464489755 0.7013349453941531 -5.527979495129065e-07 -0.09674867529635543 -1.3504 0.7013380727644751 0.7013366826074512 -5.541090427885198e-07 -0.09674964693603494 -1.3505 0.7013397985541316 0.7013384193200836 -5.553036829114566e-07 -0.09675061829014125 -1.3506000000000002 0.7013415238193369 0.7013401555309545 -5.563816308784553e-07 -0.09675158935875544 -1.3507 0.701343248561485 0.7013418912389665 -5.573426741789511e-07 -0.09675256014195852 -1.3508000000000002 0.7013449727819723 0.7013436264430198 -5.581866269060987e-07 -0.09675353063983153 -1.3509 0.7013466964821959 0.7013453611420131 -5.589133297567717e-07 -0.09675450085245546 -1.351 0.7013484196635555 0.7013470953348435 -5.595226501564632e-07 -0.09675547077991131 -1.3511000000000002 0.7013501423274511 0.7013488290204073 -5.600144821205078e-07 -0.09675644042228004 -1.3512 0.7013518644752832 0.7013505621975991 -5.603887464761259e-07 -0.09675740977964253 -1.3513000000000002 0.7013535861084534 0.7013522948653141 -5.606453906958908e-07 -0.09675837885207976 -1.3514000000000002 0.7013553072283634 0.7013540270224462 -5.607843890365061e-07 -0.09675934763967259 -1.3515 0.7013570278364145 0.70135575866789 -5.608057423583945e-07 -0.09676031614250191 -1.3516000000000001 0.7013587479340082 0.7013574898005401 -5.607094783199873e-07 -0.09676128436064858 -1.3517000000000001 0.7013604675225449 0.7013592204192916 -5.604956512528236e-07 -0.09676225229419345 -1.3518000000000001 0.7013621866034241 0.7013609505230403 -5.601643421337954e-07 -0.09676321994321734 -1.3519 0.7013639051780441 0.7013626801106836 -5.597156586961693e-07 -0.09676418730780097 -1.352 0.7013656232478019 0.70136440918112 -5.591497351659092e-07 -0.09676515438802515 -1.3521 0.7013673408140928 0.7013661377332495 -5.584667323588199e-07 -0.09676612118397063 -1.3522 0.7013690578783097 0.7013678657659745 -5.576668377360594e-07 -0.09676708769571815 -1.3523000000000003 0.701370774441843 0.7013695932781998 -5.567502651682155e-07 -0.09676805392334836 -1.3524 0.7013724905060812 0.7013713202688321 -5.557172549908174e-07 -0.09676901986694203 -1.3525 0.7013742060724093 0.7013730467367811 -5.545680738794356e-07 -0.09676998552657974 -1.3526000000000002 0.701375921142209 0.7013747726809604 -5.53303014849682e-07 -0.09677095090234217 -1.3527 0.7013776357168593 0.7013764981002857 -5.519223971184317e-07 -0.09677191599430994 -1.3528000000000002 0.7013793497977345 0.7013782229936776 -5.50426566055251e-07 -0.09677288080256363 -1.3529 0.7013810633862054 0.7013799473600597 -5.488158930921916e-07 -0.09677384532718382 -1.353 0.7013827764836384 0.7013816711983605 -5.470907756682797e-07 -0.0967748095682511 -1.3531000000000002 0.7013844890913958 0.7013833945075125 -5.452516370907379e-07 -0.09677577352584601 -1.3532 0.7013862012108343 0.7013851172864531 -5.432989263962074e-07 -0.096776737200049 -1.3533000000000002 0.7013879128433056 0.701386839534125 -5.412331183299313e-07 -0.09677770059094061 -1.3534000000000002 0.7013896239901567 0.7013885612494757 -5.390547132000378e-07 -0.09677866369860133 -1.3535 0.7013913346527276 0.7013902824314591 -5.367642367248848e-07 -0.09677962652311156 -1.3536000000000001 0.701393044832354 0.7013920030790342 -5.343622398804038e-07 -0.09678058906455178 -1.3537000000000001 0.7013947545303639 0.7013937231911662 -5.318492988931611e-07 -0.09678155132300234 -1.3538000000000001 0.70139646374808 0.7013954427668273 -5.292260149905581e-07 -0.09678251329854368 -1.3539 0.7013981724868175 0.7013971618049957 -5.264930142689916e-07 -0.09678347499125613 -1.354 0.7013998807478848 0.7013988803046569 -5.236509475967099e-07 -0.09678443640122007 -1.3541 0.7014015885325833 0.701400598264803 -5.207004904611567e-07 -0.09678539752851575 -1.3542 0.7014032958422067 0.7014023156844346 -5.176423427191712e-07 -0.09678635837322358 -1.3543000000000003 0.7014050026780408 0.701404032562559 -5.144772285067822e-07 -0.09678731893542379 -1.3544 0.7014067090413634 0.7014057488981918 -5.112058960657362e-07 -0.09678827921519659 -1.3545 0.7014084149334443 0.7014074646903572 -5.078291175283911e-07 -0.09678923921262231 -1.3546 0.7014101203555441 0.7014091799380873 -5.043476887997556e-07 -0.0967901989277811 -1.3547 0.7014118253089154 0.7014108946404228 -5.007624293146273e-07 -0.09679115836075317 -1.3548000000000002 0.7014135297948012 0.7014126087964144 -4.9707418187106e-07 -0.09679211751161873 -1.3549 0.7014152338144355 0.701414322405121 -4.932838123944405e-07 -0.09679307638045791 -1.355 0.7014169373690424 0.7014160354656112 -4.893922097778947e-07 -0.09679403496735084 -1.3551000000000002 0.7014186404598369 0.7014177479769633 -4.854002856602424e-07 -0.09679499327237766 -1.3552 0.7014203430880233 0.7014194599382656 -4.8130897422477e-07 -0.09679595129561838 -1.3553000000000002 0.7014220452547957 0.7014211713486169 -4.771192319771855e-07 -0.09679690903715317 -1.3554000000000002 0.7014237469613381 0.7014228822071256 -4.7283203750275726e-07 -0.09679786649706201 -1.3555 0.701425448208824 0.7014245925129117 -4.684483912581472e-07 -0.096798823675425 -1.3556000000000001 0.7014271489984151 0.7014263022651053 -4.639693153146718e-07 -0.0967997805723221 -1.3557000000000001 0.7014288493312624 0.701428011462848 -4.593958531431963e-07 -0.0968007371878333 -1.3558000000000001 0.7014305492085053 0.7014297201052926 -4.54729069343518e-07 -0.09680169352203855 -1.3559 0.7014322486312718 0.7014314281916034 -4.499700494778325e-07 -0.09680264957501779 -1.356 0.7014339476006783 0.7014331357209569 -4.451198997237893e-07 -0.096803605346851 -1.3561 0.7014356461178284 0.7014348426925407 -4.401797466385693e-07 -0.09680456083761797 -1.3562 0.701437344183814 0.7014365491055555 -4.3515073692296236e-07 -0.09680551604739872 -1.3563000000000003 0.7014390417997143 0.7014382549592142 -4.300340371507505e-07 -0.09680647097627304 -1.3564 0.701440738966596 0.7014399602527417 -4.2483083347727435e-07 -0.09680742562432078 -1.3565 0.7014424356855125 0.7014416649853767 -4.195423314104496e-07 -0.09680837999162176 -1.3566 0.7014441319575043 0.70144336915637 -4.141697554846391e-07 -0.09680933407825575 -1.3567 0.7014458277835989 0.701445072764986 -4.0871434900391357e-07 -0.09681028788430253 -1.3568000000000002 0.7014475231648096 0.701446775810503 -4.031773737159239e-07 -0.09681124140984187 -1.3569 0.7014492181021367 0.7014484782922122 -3.975601095829173e-07 -0.09681219465495355 -1.357 0.701450912596566 0.7014501802094188 -3.918638544278541e-07 -0.09681314761971715 -1.3571000000000002 0.7014526066490698 0.7014518815614426 -3.8608992369848494e-07 -0.09681410030421246 -1.3572 0.7014543002606058 0.7014535823476165 -3.8023965006489524e-07 -0.09681505270851916 -1.3573000000000002 0.7014559934321175 0.7014552825672886 -3.7431438323215493e-07 -0.09681600483271685 -1.3574000000000002 0.7014576861645334 0.7014569822198213 -3.6831548952398485e-07 -0.0968169566768852 -1.3575 0.7014593784587675 0.7014586813045918 -3.622443516607121e-07 -0.09681790824110381 -1.3576000000000001 0.7014610703157188 0.701460379820992 -3.5610236831518094e-07 -0.09681885952545226 -1.3577000000000001 0.7014627617362711 0.7014620777684287 -3.4989095396703584e-07 -0.0968198105300101 -1.3578000000000001 0.7014644527212928 0.7014637751463244 -3.436115384100602e-07 -0.09682076125485685 -1.3579 0.701466143271637 0.7014654719541167 -3.3726556652319273e-07 -0.0968217117000721 -1.358 0.7014678333881414 0.7014671681912585 -3.30854497909705e-07 -0.09682266186573532 -1.3581 0.7014695230716277 0.7014688638572191 -3.243798065502568e-07 -0.096823611751926 -1.3582 0.7014712123229014 0.7014705589514826 -3.1784298046982906e-07 -0.09682456135872358 -1.3583000000000003 0.7014729011427526 0.7014722534735501 -3.112455214393517e-07 -0.09682551068620754 -1.3584 0.7014745895319547 0.7014739474229382 -3.045889445246752e-07 -0.09682645973445728 -1.3585 0.7014762774912648 0.7014756407991798 -2.978747778575874e-07 -0.09682740850355216 -1.3586 0.7014779650214237 0.7014773336018245 -2.9110456220907133e-07 -0.0968283569935716 -1.3587 0.7014796521231554 0.7014790258304382 -2.842798506874633e-07 -0.09682930520459494 -1.3588000000000002 0.7014813387971675 0.7014807174846035 -2.7740220833599727e-07 -0.09683025313670153 -1.3589 0.7014830250441505 0.7014824085639197 -2.7047321180320716e-07 -0.09683120078997068 -1.359 0.7014847108647778 0.7014840990680031 -2.634944489543489e-07 -0.09683214816448166 -1.3591000000000002 0.7014863962597061 0.701485788996487 -2.5646751853486416e-07 -0.09683309526031376 -1.3592 0.7014880812295745 0.7014874783490216 -2.493940298303743e-07 -0.09683404207754624 -1.3593000000000002 0.7014897657750049 0.7014891671252745 -2.422756022191219e-07 -0.09683498861625829 -1.3594000000000002 0.7014914498966021 0.7014908553249313 -2.3511386486319008e-07 -0.09683593487652918 -1.3595 0.7014931335949529 0.7014925429476939 -2.2791045630604634e-07 -0.09683688085843807 -1.3596000000000001 0.701494816870627 0.7014942299932821 -2.206670241151898e-07 -0.09683782656206413 -1.3597000000000001 0.7014964997241757 0.7014959164614336 -2.1338522453173692e-07 -0.09683877198748649 -1.3598000000000001 0.7014981821561335 0.7014976023519038 -2.0606672201939347e-07 -0.09683971713478434 -1.3599 0.7014998641670158 0.7014992876644656 -1.98713188934857e-07 -0.09684066200403667 -1.36 0.7015015457573213 0.7015009723989097 -1.9132630515311666e-07 -0.09684160659532265 -1.3601 0.7015032269275296 0.7015026565550454 -1.8390775766846668e-07 -0.09684255090872132 -1.3602 0.7015049076781031 0.7015043401326992 -1.7645924019205061e-07 -0.09684349494431173 -1.3603000000000003 0.7015065880094855 0.7015060231317165 -1.6898245276675272e-07 -0.0968444387021729 -1.3604 0.7015082679221023 0.7015077055519601 -1.6147910144280464e-07 -0.09684538218238385 -1.3605 0.7015099474163611 0.7015093873933114 -1.5395089780073645e-07 -0.09684632538502352 -1.3606 0.7015116264926502 0.7015110686556698 -1.4639955861137088e-07 -0.09684726831017085 -1.3607 0.7015133051513408 0.7015127493389535 -1.3882680544204107e-07 -0.09684821095790483 -1.3608000000000002 0.7015149833927847 0.7015144294430987 -1.3123436424199164e-07 -0.09684915332830436 -1.3609 0.7015166612173158 0.7015161089680599 -1.2362396497635209e-07 -0.09685009542144835 -1.361 0.7015183386252491 0.7015177879138108 -1.1599734120806837e-07 -0.09685103723741571 -1.3611000000000002 0.701520015616881 0.701519466280342 -1.0835622971799852e-07 -0.09685197877628518 -1.3612 0.7015216921924898 0.7015211440676643 -1.0070237010679356e-07 -0.09685292003813567 -1.3613000000000002 0.701523368352335 0.7015228212758062 -9.303750440285002e-08 -0.09685386102304602 -1.3614000000000002 0.7015250440966567 0.7015244979048147 -8.536337665031313e-08 -0.09685480173109498 -1.3615 0.7015267194256776 0.701526173954756 -7.768173252657024e-08 -0.09685574216236131 -1.3616000000000001 0.7015283943396007 0.7015278494257136 -6.999431894499919e-08 -0.09685668231692376 -1.3617000000000001 0.7015300688386112 0.7015295243177911 -6.23028836516451e-08 -0.0968576221948611 -1.3618000000000001 0.701531742922875 0.7015311986311099 -5.46091748286192e-08 -0.09685856179625206 -1.3619 0.7015334165925395 0.7015328723658101 -4.691494070443655e-08 -0.09685950112117529 -1.362 0.7015350898477337 0.7015345455220503 -3.9221929147494495e-08 -0.09686044016970946 -1.3621 0.7015367626885671 0.7015362181000077 -3.153188727321194e-08 -0.09686137894193317 -1.3622 0.7015384351151319 0.7015378900998781 -2.3846561048729287e-08 -0.0968623174379251 -1.3623000000000003 0.7015401071275003 0.701539561521876 -1.6167694895981993e-08 -0.09686325565776382 -1.3624 0.7015417787257269 0.7015412323662344 -8.497031291250512e-09 -0.09686419360152798 -1.3625 0.701543449909847 0.7015429026332047 -8.363103768532776e-10 -0.09686513126929605 -1.3626 0.701545120679878 0.7015445723230568 6.8127304405501965e-09 -0.09686606866114666 -1.3627 0.7015467910358183 0.701546241436079 1.4448356873766888e-08 -0.09686700577715832 -1.3628000000000002 0.7015484609776479 0.7015479099725783 2.2068838163163962e-08 -0.09686794261740948 -1.3629 0.7015501305053284 0.7015495779328793 2.9672447450501682e-08 -0.09686887918197865 -1.363 0.7015517996188033 0.7015512453173258 3.7257462186593426e-08 -0.09686981547094431 -1.3631000000000002 0.7015534683179974 0.7015529121262796 4.482216451814902e-08 -0.09687075148438487 -1.3632 0.701555136602817 0.7015545783601205 5.236484166594446e-08 -0.09687168722237878 -1.3633000000000002 0.7015568044731504 0.7015562440192464 5.988378632554303e-08 -0.09687262268500435 -1.3634000000000002 0.7015584719288681 0.7015579091040738 6.737729704546502e-08 -0.09687355787234009 -1.3635 0.7015601389698224 0.7015595736150366 7.484367861403107e-08 -0.09687449278446429 -1.3636000000000001 0.7015618055958466 0.7015612375525873 8.228124244273605e-08 -0.09687542742145525 -1.3637000000000001 0.7015634718067574 0.7015629009171952 8.968830695829655e-08 -0.09687636178339129 -1.3638000000000001 0.701565137602353 0.7015645637093488 9.706319796867757e-08 -0.09687729587035081 -1.3639000000000001 0.7015668029824136 0.7015662259295535 1.0440424903085388e-07 -0.09687822968241198 -1.364 0.7015684679467019 0.7015678875783324 1.1170980188102142e-07 -0.09687916321965309 -1.3641 0.7015701324949633 0.7015695486562259 1.1897820672082671e-07 -0.09688009648215234 -1.3642 0.701571796626925 0.7015712091637925 1.2620782267880326e-07 -0.09688102946998799 -1.3643000000000003 0.7015734603422974 0.7015728691016077 1.3339701812956073e-07 -0.09688196218323819 -1.3644 0.7015751236407732 0.7015745284702639 1.405441710719546e-07 -0.09688289462198112 -1.3645 0.7015767865220282 0.7015761872703712 1.4764766950725594e-07 -0.09688382678629492 -1.3646 0.7015784489857204 0.7015778455025565 1.5470591177915716e-07 -0.0968847586762577 -1.3647 0.7015801110314921 0.7015795031674634 1.617173069484723e-07 -0.09688569029194766 -1.3648000000000002 0.7015817726589675 0.7015811602657529 1.6868027516783735e-07 -0.0968866216334428 -1.3649 0.7015834338677549 0.7015828167981017 1.7559324800783815e-07 -0.09688755270082126 -1.365 0.7015850946574453 0.7015844727652039 1.8245466882824135e-07 -0.09688848349416102 -1.3651000000000002 0.7015867550276136 0.7015861281677698 1.8926299313881678e-07 -0.09688941401354013 -1.3652 0.701588414977818 0.7015877830065254 1.960166889011794e-07 -0.09689034425903657 -1.3653000000000002 0.7015900745076011 0.7015894372822138 2.0271423694165347e-07 -0.09689127423072835 -1.3654000000000002 0.7015917336164887 0.7015910909955935 2.093541312218894e-07 -0.09689220392869341 -1.3655 0.7015933923039915 0.7015927441474389 2.159348792274418e-07 -0.09689313335300975 -1.3656000000000001 0.7015950505696037 0.7015943967385403 2.2245500230083648e-07 -0.09689406250375526 -1.3657000000000001 0.701596708412804 0.7015960487697033 2.2891303595035106e-07 -0.09689499138100782 -1.3658000000000001 0.7015983658330558 0.7015977002417492 2.3530753015532646e-07 -0.09689591998484537 -1.3659000000000001 0.7016000228298069 0.7015993511555143 2.416370497859699e-07 -0.09689684831534566 -1.366 0.7016016794024904 0.7016010015118501 2.479001748184606e-07 -0.09689777637258662 -1.3661 0.701603335550524 0.7016026513116231 2.540955007374057e-07 -0.09689870415664609 -1.3662 0.7016049912733108 0.7016043005557142 2.602216387925793e-07 -0.09689963166760175 -1.3663000000000003 0.7016066465702392 0.7016059492450193 2.6627721630423373e-07 -0.09690055890553151 -1.3664 0.7016083014406829 0.7016075973804488 2.722608770447388e-07 -0.09690148587051309 -1.3665 0.7016099558840014 0.7016092449629263 2.781712814953208e-07 -0.09690241256262416 -1.3666 0.7016116098995406 0.7016108919933908 2.8400710710974053e-07 -0.0969033389819425 -1.3667 0.7016132634866317 0.7016125384727943 2.897670486820547e-07 -0.0969042651285458 -1.3668000000000002 0.7016149166445924 0.7016141844021028 2.954498185617216e-07 -0.09690519100251171 -1.3669 0.7016165693727269 0.7016158297822956 3.0105414701442346e-07 -0.0969061166039179 -1.367 0.7016182216703264 0.7016174746143655 3.06578782464928e-07 -0.09690704193284204 -1.3671000000000002 0.7016198735366683 0.7016191188993183 3.120224917954606e-07 -0.09690796698936169 -1.3672 0.7016215249710173 0.7016207626381725 3.173840606163214e-07 -0.09690889177355447 -1.3673000000000002 0.7016231759726252 0.7016224058319595 3.2266229350180753e-07 -0.0969098162854979 -1.3674000000000002 0.7016248265407319 0.7016240484817231 3.2785601430246336e-07 -0.0969107405252696 -1.3675 0.7016264766745641 0.7016256905885196 3.3296406639488074e-07 -0.09691166449294712 -1.3676000000000001 0.701628126373337 0.7016273321534167 3.379853129523158e-07 -0.09691258818860789 -1.3677000000000001 0.7016297756362531 0.7016289731774947 3.429186371251003e-07 -0.0969135116123294 -1.3678000000000001 0.7016314244625041 0.7016306136618452 3.47762942394525e-07 -0.0969144347641892 -1.3679000000000001 0.7016330728512699 0.7016322536075712 3.5251715273243445e-07 -0.0969153576442647 -1.368 0.7016347208017186 0.7016338930157868 3.571802129342938e-07 -0.09691628025263332 -1.3681 0.701636368313008 0.7016355318876175 3.617510887440889e-07 -0.09691720258937252 -1.3682 0.7016380153842845 0.701637170224199 3.662287671249431e-07 -0.09691812465455958 -1.3683 0.7016396620146844 0.7016388080266779 3.7061225654361207e-07 -0.09691904644827196 -1.3684 0.7016413082033335 0.7016404452962105 3.7490058710926144e-07 -0.09691996797058695 -1.3685 0.701642953949347 0.7016420820339642 3.790928107885727e-07 -0.09692088922158194 -1.3686 0.7016445992518311 0.701643718241115 3.831880016832989e-07 -0.0969218102013342 -1.3687 0.7016462441098814 0.7016453539188494 3.87185256203737e-07 -0.09692273090992098 -1.3688000000000002 0.701647888522585 0.7016469890683625 3.9108369324220016e-07 -0.09692365134741959 -1.3689 0.7016495324890191 0.7016486236908596 3.9488245435342906e-07 -0.09692457151390729 -1.369 0.7016511760082524 0.7016502577875534 3.9858070400439205e-07 -0.09692549140946127 -1.3691000000000002 0.7016528190793447 0.7016518913596659 4.021776297546964e-07 -0.09692641103415874 -1.3692 0.7016544617013476 0.7016535244084279 4.0567244240230504e-07 -0.09692733038807685 -1.3693000000000002 0.701656103873304 0.7016551569350774 4.090643760945589e-07 -0.09692824947129279 -1.3694000000000002 0.7016577455942496 0.701656788940861 4.1235268866818275e-07 -0.0969291682838837 -1.3695 0.7016593868632122 0.7016584204270329 4.1553666162846836e-07 -0.09693008682592674 -1.3696000000000002 0.7016610276792117 0.7016600513948534 4.1861560039907486e-07 -0.09693100509749897 -1.3697000000000001 0.7016626680412614 0.7016616818455919 4.215888345024399e-07 -0.09693192309867746 -1.3698000000000001 0.7016643079483675 0.7016633117805229 4.244557176083519e-07 -0.0969328408295393 -1.3699000000000001 0.7016659473995297 0.7016649412009284 4.2721562776987243e-07 -0.09693375829016154 -1.37 0.7016675863937409 0.7016665701080964 4.2986796752741974e-07 -0.09693467548062121 -1.3701 0.7016692249299883 0.7016681985033209 4.3241216395734083e-07 -0.09693559240099525 -1.3702 0.7016708630072527 0.7016698263879018 4.3484766894252846e-07 -0.09693650905136064 -1.3703 0.70167250062451 0.7016714537631444 4.3717395918629887e-07 -0.09693742543179437 -1.3704 0.7016741377807306 0.7016730806303593 4.3939053635116965e-07 -0.09693834154237335 -1.3705 0.7016757744748797 0.7016747069908622 4.4149692719763767e-07 -0.09693925738317455 -1.3706 0.7016774107059176 0.7016763328459734 4.4349268357030125e-07 -0.09694017295427486 -1.3707 0.7016790464728002 0.7016779581970178 4.4537738265459925e-07 -0.0969410882557511 -1.3708000000000002 0.7016806817744792 0.7016795830453243 4.4715062698374997e-07 -0.0969420032876802 -1.3709 0.7016823166099022 0.7016812073922254 4.4881204450814005e-07 -0.09694291805013891 -1.371 0.7016839509780132 0.7016828312390577 4.5036128867165237e-07 -0.09694383254320409 -1.3711000000000002 0.7016855848777527 0.7016844545871612 4.5179803855738276e-07 -0.09694474676695256 -1.3712 0.701687218308058 0.7016860774378789 4.531219988390678e-07 -0.09694566072146107 -1.3713000000000002 0.7016888512678638 0.7016876997925561 4.5433289996149595e-07 -0.09694657440680637 -1.3714000000000002 0.7016904837561018 0.7016893216525414 4.55430498057241e-07 -0.09694748782306518 -1.3715 0.7016921157717017 0.7016909430191852 4.5641457517564543e-07 -0.09694840097031426 -1.3716000000000002 0.7016937473135907 0.70169256389384 4.572849391856759e-07 -0.0969493138486303 -1.3717000000000001 0.7016953783806945 0.7016941842778599 4.580414237481678e-07 -0.09695022645808989 -1.3718000000000001 0.7016970089719377 0.7016958041726005 4.586838886141975e-07 -0.09695113879876976 -1.3719000000000001 0.701698639086243 0.7016974235794187 4.5921221937528234e-07 -0.09695205087074654 -1.372 0.7017002687225322 0.7016990424996723 4.5962632762991396e-07 -0.09695296267409681 -1.3721 0.7017018978797267 0.7017006609347193 4.599261509696806e-07 -0.09695387420889717 -1.3722 0.7017035265567476 0.7017022788859182 4.601116529306948e-07 -0.09695478547522418 -1.3723 0.7017051547525156 0.701703896354628 4.60182823083799e-07 -0.09695569647315444 -1.3724 0.7017067824659515 0.701705513342207 4.6013967697905445e-07 -0.09695660720276444 -1.3725 0.7017084096959769 0.701707129850013 4.599822560971689e-07 -0.0969575176641307 -1.3726 0.7017100364415139 0.7017087458794032 4.59710627960519e-07 -0.09695842785732972 -1.3727 0.7017116627014852 0.7017103614317334 4.593248859666166e-07 -0.09695933778243791 -1.3728000000000002 0.7017132884748154 0.7017119765083584 4.588251494158646e-07 -0.09696024743953176 -1.3729 0.7017149137604306 0.7017135911106316 4.582115635323736e-07 -0.09696115682868776 -1.373 0.701716538557258 0.701715205239904 4.5748429933906154e-07 -0.09696206594998226 -1.3731000000000002 0.7017181628642277 0.7017168188975247 4.566435536298985e-07 -0.09696297480349167 -1.3732 0.7017197866802718 0.7017184320848402 4.5568954897684533e-07 -0.09696388338929231 -1.3733000000000002 0.7017214100043248 0.7017200448031943 4.5462253361189253e-07 -0.09696479170746054 -1.3734000000000002 0.7017230328353243 0.701721657053928 4.534427814062436e-07 -0.09696569975807269 -1.3735 0.7017246551722117 0.701723268838379 4.5215059175235384e-07 -0.09696660754120508 -1.3736000000000002 0.701726277013931 0.7017248801578815 4.50746289515358e-07 -0.09696751505693404 -1.3737000000000001 0.7017278983594301 0.7017264910137662 4.492302249567426e-07 -0.09696842230533581 -1.3738000000000001 0.7017295192076609 0.7017281014073586 4.4760277365801793e-07 -0.09696932928648662 -1.3739000000000001 0.70173113955758 0.701729711339981 4.45864336402757e-07 -0.09697023600046267 -1.374 0.7017327594081482 0.7017313208129508 4.44015339079451e-07 -0.0969711424473402 -1.3741 0.701734378758331 0.7017329298275801 4.4205623261905913e-07 -0.09697204862719544 -1.3742 0.7017359976070987 0.7017345383851765 4.399874928076586e-07 -0.09697295454010442 -1.3743 0.7017376159534278 0.7017361464870422 4.3780962026562786e-07 -0.09697386018614346 -1.3744 0.7017392337962995 0.7017377541344731 4.355231402394799e-07 -0.09697476556538859 -1.3745 0.7017408511347015 0.7017393613287596 4.33128602546351e-07 -0.09697567067791592 -1.3746 0.7017424679676271 0.7017409680711856 4.3062658141440613e-07 -0.09697657552380151 -1.3747 0.7017440842940761 0.7017425743630291 4.2801767532324453e-07 -0.09697748010312146 -1.3748000000000002 0.7017457001130553 0.701744180205561 4.253025068998162e-07 -0.0969783844159518 -1.3749 0.7017473154235778 0.7017457856000453 4.2248172272413287e-07 -0.09697928846236858 -1.375 0.7017489302246644 0.7017473905477385 4.1955599326681803e-07 -0.09698019224244774 -1.3751000000000002 0.7017505445153431 0.7017489950498906 4.165260125976733e-07 -0.09698109575626535 -1.3752 0.7017521582946491 0.701750599107743 4.1339249832322844e-07 -0.09698199900389731 -1.3753000000000002 0.701753771561626 0.7017522027225293 4.101561914063301e-07 -0.09698290198541959 -1.3754000000000002 0.7017553843153255 0.7017538058954749 4.0681785593715825e-07 -0.09698380470090812 -1.3755 0.7017569965548072 0.701755408627797 4.0337827900138734e-07 -0.09698470715043878 -1.3756000000000002 0.70175860827914 0.7017570109207039 3.9983827049283605e-07 -0.09698560933408747 -1.3757000000000001 0.7017602194874013 0.7017586127753948 3.961986629053005e-07 -0.09698651125193003 -1.3758000000000001 0.7017618301786774 0.7017602141930601 3.924603111382652e-07 -0.09698741290404231 -1.3759000000000001 0.7017634403520643 0.7017618151748803 3.886240922817974e-07 -0.09698831429050012 -1.376 0.7017650500066677 0.7017634157220275 3.846909054638914e-07 -0.09698921541137938 -1.3761 0.7017666591416023 0.701765015835662 3.8066167160066833e-07 -0.09699011626675573 -1.3762 0.7017682677559938 0.7017666155169351 3.765373331535149e-07 -0.09699101685670494 -1.3763 0.7017698758489775 0.7017682147669881 3.723188540111222e-07 -0.09699191718130286 -1.3764 0.7017714834196995 0.7017698135869508 3.6800721916335766e-07 -0.09699281724062508 -1.3765 0.7017730904673165 0.7017714119779428 3.636034344792205e-07 -0.09699371703474736 -1.3766 0.7017746969909961 0.7017730099410726 3.5910852653336933e-07 -0.0969946165637454 -1.3767 0.7017763029899173 0.7017746074774376 3.5452354231468863e-07 -0.09699551582769483 -1.3768000000000002 0.70177790846327 0.7017762045881235 3.498495490250608e-07 -0.09699641482667132 -1.3769 0.7017795134102561 0.7017778012742046 3.4508763377405494e-07 -0.09699731356075048 -1.377 0.701781117830089 0.7017793975367428 3.402389033638209e-07 -0.09699821203000784 -1.3771000000000002 0.7017827217219943 0.7017809933767885 3.3530448404622826e-07 -0.09699911023451903 -1.3772 0.7017843250852098 0.7017825887953801 3.302855212591882e-07 -0.09700000817435972 -1.3773000000000002 0.7017859279189855 0.7017841837935426 3.2518317930052554e-07 -0.09700090584960533 -1.3774000000000002 0.7017875302225842 0.7017857783722891 3.199986411475675e-07 -0.0970018032603314 -1.3775 0.7017891319952813 0.7017873725326194 3.147331080685656e-07 -0.09700270040661343 -1.3776000000000002 0.7017907332363653 0.7017889662755207 3.093877994839178e-07 -0.09700359728852698 -1.3777000000000001 0.7017923339451378 0.7017905596019661 3.0396395259146836e-07 -0.09700449390614738 -1.3778000000000001 0.7017939341209136 0.7017921525129163 2.984628221236463e-07 -0.0970053902595501 -1.3779000000000001 0.7017955337630216 0.7017937450093175 2.9288567999358195e-07 -0.0970062863488106 -1.378 0.7017971328708039 0.7017953370921028 2.87233815100818e-07 -0.09700718217400428 -1.3781 0.7017987314436165 0.7017969287621911 2.815085329149758e-07 -0.09700807773520648 -1.3782 0.7018003294808299 0.701798520020487 2.7571115529534396e-07 -0.0970089730324926 -1.3783 0.7018019269818282 0.7018001108678806 2.6984302011617833e-07 -0.09700986806593791 -1.3784 0.7018035239460109 0.7018017013052482 2.6390548093363497e-07 -0.09701076283561788 -1.3785 0.7018051203727911 0.7018032913334508 2.5789990676372554e-07 -0.09701165734160766 -1.3786 0.7018067162615971 0.7018048809533346 2.518276816729226e-07 -0.09701255158398261 -1.3787 0.7018083116118716 0.7018064701657314 2.4569020451448154e-07 -0.09701344556281793 -1.3788000000000002 0.7018099064230732 0.7018080589714573 2.394888885745572e-07 -0.09701433927818888 -1.3789 0.7018115006946752 0.7018096473713133 2.3322516129464788e-07 -0.09701523273017071 -1.379 0.7018130944261662 0.7018112353660855 2.269004639177119e-07 -0.09701612591883864 -1.3791000000000002 0.7018146876170506 0.7018128229565436 2.205162511134673e-07 -0.09701701884426783 -1.3792 0.7018162802668477 0.7018144101434419 2.1407399073553046e-07 -0.09701791150653342 -1.3793000000000002 0.7018178723750933 0.7018159969275188 2.075751633807965e-07 -0.0970188039057105 -1.3794000000000002 0.7018194639413391 0.7018175833094972 2.010212621465779e-07 -0.09701969604187426 -1.3795 0.7018210549651521 0.7018191692900833 1.9441379221774024e-07 -0.09702058791509977 -1.3796000000000002 0.7018226454461163 0.7018207548699673 1.8775427052669658e-07 -0.0970214795254621 -1.3797000000000001 0.7018242353838315 0.7018223400498234 1.810442254515654e-07 -0.09702237087303636 -1.3798000000000001 0.7018258247779139 0.7018239248303088 1.7428519644147045e-07 -0.09702326195789752 -1.3799000000000001 0.7018274136279965 0.7018255092120644 1.6747873365224875e-07 -0.09702415278012072 -1.38 0.7018290019337288 0.7018270931957145 1.6062639759603647e-07 -0.09702504333978086 -1.3801 0.7018305896947766 0.701828676781866 1.5372975877350759e-07 -0.09702593363695296 -1.3802 0.7018321769108231 0.7018302599711096 1.467903973546847e-07 -0.09702682367171195 -1.3803 0.7018337635815677 0.7018318427640188 1.3980990277301375e-07 -0.09702771344413275 -1.3804 0.7018353497067278 0.7018334251611498 1.327898733784194e-07 -0.09702860295429028 -1.3805 0.7018369352860372 0.7018350071630419 1.2573191608342138e-07 -0.09702949220225948 -1.3806 0.7018385203192468 0.7018365887702172 1.186376459606786e-07 -0.0970303811881152 -1.3807 0.7018401048061254 0.70183816998318 1.115086859203307e-07 -0.09703126991193234 -1.3808000000000002 0.7018416887464587 0.7018397508024177 1.0434666631101153e-07 -0.0970321583737857 -1.3809 0.70184327214005 0.7018413312283993 9.715322453127118e-08 -0.0970330465737501 -1.381 0.7018448549867202 0.7018429112615776 8.993000470691737e-08 -0.09703393451190036 -1.3811000000000002 0.7018464372863074 0.7018444909023869 8.267865726080403e-08 -0.09703482218831125 -1.3812 0.7018480190386674 0.7018460701512435 7.540083855374358e-08 -0.09703570960305755 -1.3813000000000002 0.701849600243674 0.7018476490085466 6.809821052888854e-08 -0.09703659675621394 -1.3814000000000002 0.7018511809012187 0.7018492274746773 6.07724403127452e-08 -0.0970374836478552 -1.3815 0.7018527610112106 0.7018508055499987 5.3425199824860825e-08 -0.09703837027805605 -1.3816000000000002 0.7018543405735768 0.7018523832348564 4.605816542220531e-08 -0.0970392566468911 -1.3817000000000002 0.7018559195882621 0.7018539605295776 3.867301749324592e-08 -0.09704014275443508 -1.3818000000000001 0.701857498055229 0.7018555374344715 3.127144008498173e-08 -0.09704102860076252 -1.3819000000000001 0.7018590759744587 0.7018571139498296 2.3855120531712792e-08 -0.09704191418594814 -1.382 0.7018606533459499 0.7018586900759253 1.6425749038706527e-08 -0.09704279951006653 -1.3821 0.7018622301697195 0.7018602658130134 8.985018329181471e-09 -0.09704368457319221 -1.3822 0.701863806445802 0.7018618411613315 1.534623243586164e-09 -0.09704456937539983 -1.3823 0.7018653821742505 0.7018634161210984 -5.923739649846271e-09 -0.09704545391676389 -1.3824 0.701866957355136 0.7018649906925146 -1.338837243413521e-08 -0.0970463381973589 -1.3825 0.7018685319885474 0.7018665648757629 -2.08575762316969e-08 -0.09704722221725937 -1.3826 0.7018701060745919 0.7018681386710077 -2.832965158858572e-08 -0.09704810597653979 -1.3827 0.7018716796133945 0.7018697120783954 -3.580289886524063e-08 -0.09704898947527456 -1.3828000000000003 0.7018732526050987 0.7018712850980542 -4.327561862040117e-08 -0.0970498727135382 -1.3829 0.7018748250498659 0.7018728577300939 -5.0746111999035e-08 -0.09705075569140509 -1.383 0.7018763969478754 0.7018744299746067 -5.821268111755491e-08 -0.09705163840894968 -1.3831000000000002 0.701877968299325 0.7018760018316662 -6.567362944871064e-08 -0.09705252086624634 -1.3832 0.7018795391044299 0.7018775733013279 -7.312726221005844e-08 -0.09705340306336943 -1.3833000000000002 0.7018811093634236 0.7018791443836292 -8.057188674321508e-08 -0.09705428500039322 -1.3834000000000002 0.7018826790765578 0.70188071507859 -8.800581290709791e-08 -0.09705516667739211 -1.3835 0.7018842482441019 0.701882285386211 -9.542735345154096e-08 -0.09705604809444036 -1.3836000000000002 0.7018858168663433 0.7018838553064767 -1.0283482440674035e-07 -0.09705692925161233 -1.3837000000000002 0.7018873849435873 0.7018854248393518 -1.1022654545882193e-07 -0.09705781014898218 -1.3838000000000001 0.7018889524761568 0.7018869939847843 -1.1760084034535823e-07 -0.09705869078662421 -1.3839000000000001 0.7018905194643932 0.7018885627427036 -1.2495603722226245e-07 -0.09705957116461267 -1.384 0.7018920859086546 0.7018901311130221 -1.3229046903935615e-07 -0.09706045128302174 -1.3841 0.7018936518093175 0.7018916990956338 -1.396024739280799e-07 -0.09706133114192561 -1.3842 0.7018952171667758 0.7018932666904147 -1.4689039557792827e-07 -0.0970622107413984 -1.3843 0.701896781981441 0.7018948338972243 -1.5415258360941542e-07 -0.0970630900815143 -1.3844 0.7018983462537418 0.7018964007159032 -1.613873939470406e-07 -0.09706396916234736 -1.3845 0.701899909984125 0.7018979671462755 -1.6859318918531485e-07 -0.09706484798397173 -1.3846 0.701901473173054 0.7018995331881478 -1.7576833896693067e-07 -0.09706572654646153 -1.3847 0.7019030358210101 0.701901098841309 -1.8291122034705398e-07 -0.09706660484989081 -1.3848000000000003 0.701904597928491 0.7019026641055306 -1.9002021817843273e-07 -0.09706748289433359 -1.3849 0.7019061594960125 0.7019042289805677 -1.970937254375249e-07 -0.09706836067986394 -1.385 0.7019077205241069 0.7019057934661577 -2.041301436286891e-07 -0.09706923820655587 -1.3851000000000002 0.7019092810133227 0.7019073575620212 -2.1112788311378194e-07 -0.09707011547448335 -1.3852 0.7019108409642264 0.7019089212678615 -2.1808536350767516e-07 -0.09707099248372031 -1.3853000000000002 0.7019124003774004 0.7019104845833659 -2.25001014000914e-07 -0.09707186923434075 -1.3854000000000002 0.7019139592534442 0.7019120475082044 -2.3187327372400923e-07 -0.09707274572641852 -1.3855 0.7019155175929734 0.7019136100420307 -2.3870059210825967e-07 -0.09707362196002758 -1.3856000000000002 0.7019170753966202 0.7019151721844821 -2.4548142922922733e-07 -0.09707449793524182 -1.3857000000000002 0.7019186326650328 0.7019167339351793 -2.522142561467433e-07 -0.09707537365213509 -1.3858000000000001 0.7019201893988763 0.7019182952937271 -2.5889755525185243e-07 -0.0970762491107813 -1.3859000000000001 0.7019217455988308 0.701919856259714 -2.6552982062763575e-07 -0.09707712431125419 -1.386 0.7019233012655928 0.7019214168327127 -2.72109558378808e-07 -0.09707799925362763 -1.3861 0.7019248563998746 0.7019229770122801 -2.786352869578457e-07 -0.09707887393797543 -1.3862 0.7019264110024036 0.7019245367979574 -2.851055375084621e-07 -0.09707974836437128 -1.3863 0.7019279650739232 0.7019260961892702 -2.9151885418479684e-07 -0.09708062253288896 -1.3864 0.7019295186151923 0.7019276551857281 -2.9787379449142115e-07 -0.09708149644360223 -1.3865 0.7019310716269843 0.7019292137868263 -3.041689296268135e-07 -0.09708237009658473 -1.3866 0.7019326241100882 0.7019307719920447 -3.104028447331597e-07 -0.09708324349191018 -1.3867 0.7019341760653077 0.7019323298008481 -3.165741392988086e-07 -0.09708411662965231 -1.3868000000000003 0.7019357274934613 0.7019338872126865 -3.2268142740460304e-07 -0.09708498950988474 -1.3869 0.7019372783953819 0.7019354442269952 -3.287233381055188e-07 -0.09708586213268106 -1.387 0.7019388287719168 0.7019370008431953 -3.346985156943427e-07 -0.09708673449811492 -1.3871000000000002 0.701940378623928 0.7019385570606932 -3.4060561999310623e-07 -0.0970876066062599 -1.3872 0.7019419279522909 0.7019401128788815 -3.464433266653355e-07 -0.09708847845718961 -1.3873000000000002 0.7019434767578953 0.7019416682971387 -3.522103275560573e-07 -0.09708935005097757 -1.3874000000000002 0.701945025041644 0.7019432233148293 -3.5790533094159915e-07 -0.09709022138769728 -1.3875 0.7019465728044545 0.7019447779313044 -3.6352706178632843e-07 -0.0970910924674223 -1.3876000000000002 0.7019481200472567 0.7019463321459019 -3.6907426208959704e-07 -0.0970919632902261 -1.3877000000000002 0.7019496667709944 0.7019478859579458 -3.7454569116329717e-07 -0.09709283385618218 -1.3878000000000001 0.7019512129766234 0.7019494393667474 -3.799401258747226e-07 -0.09709370416536398 -1.3879000000000001 0.7019527586651138 0.7019509923716054 -3.852563609449411e-07 -0.09709457421784495 -1.388 0.7019543038374464 0.7019525449718055 -3.9049320917777797e-07 -0.09709544401369848 -1.3881000000000001 0.7019558484946159 0.7019540971666208 -3.956495018414552e-07 -0.09709631355299796 -1.3882 0.7019573926376287 0.7019556489553126 -4.007240887379804e-07 -0.09709718283581678 -1.3883 0.7019589362675034 0.7019572003371295 -4.0571583861948035e-07 -0.09709805186222832 -1.3884 0.70196047938527 0.7019587513113088 -4.1062363940330693e-07 -0.09709892063230591 -1.3885 0.7019620219919702 0.7019603018770755 -4.154463983663259e-07 -0.0970997891461228 -1.3886 0.7019635640886575 0.7019618520336441 -4.201830424641062e-07 -0.09710065740375241 -1.3887 0.7019651056763963 0.701963401780217 -4.2483251851827e-07 -0.09710152540526798 -1.3888000000000003 0.7019666467562615 0.7019649511159853 -4.29393793452415e-07 -0.09710239315074262 -1.3889 0.7019681873293397 0.7019665000401304 -4.3386585452803716e-07 -0.09710326064024973 -1.389 0.7019697273967276 0.7019680485518222 -4.3824770961514714e-07 -0.09710412787386248 -1.3891000000000002 0.7019712669595317 0.7019695966502209 -4.425383872894151e-07 -0.09710499485165414 -1.3892 0.7019728060188694 0.7019711443344757 -4.467369372068708e-07 -0.09710586157369777 -1.3893000000000002 0.701974344575867 0.7019726916037268 -4.508424302357428e-07 -0.09710672804006663 -1.3894000000000002 0.7019758826316618 0.7019742384571038 -4.548539586438083e-07 -0.09710759425083382 -1.3895 0.7019774201873987 0.7019757848937278 -4.5877063629962134e-07 -0.09710846020607243 -1.3896000000000002 0.7019789572442334 0.7019773309127098 -4.6259159888761836e-07 -0.0971093259058556 -1.3897 0.7019804938033296 0.7019788765131523 -4.663160041648573e-07 -0.09711019135025642 -1.3898000000000001 0.7019820298658603 0.701980421694149 -4.699430319887732e-07 -0.09711105653934798 -1.3899000000000001 0.701983565433006 0.7019819664547848 -4.734718846641228e-07 -0.09711192147320326 -1.39 0.7019851005059561 0.7019835107941363 -4.769017869984959e-07 -0.09711278615189527 -1.3901000000000001 0.7019866350859081 0.7019850547112727 -4.802319865174209e-07 -0.09711365057549705 -1.3902 0.7019881691740668 0.7019865982052551 -4.834617536655927e-07 -0.09711451474408161 -1.3903 0.7019897027716446 0.7019881412751365 -4.865903818832007e-07 -0.0971153786577219 -1.3904 0.7019912358798615 0.7019896839199629 -4.896171878765454e-07 -0.09711624231649085 -1.3905 0.7019927684999439 0.7019912261387737 -4.925415116319165e-07 -0.0971171057204614 -1.3906 0.701994300633125 0.7019927679306014 -4.953627166376373e-07 -0.09711796886970646 -1.3907 0.7019958322806449 0.7019943092944712 -4.980801900436593e-07 -0.09711883176429889 -1.3908000000000003 0.7019973634437495 0.7019958502294026 -5.006933427378901e-07 -0.09711969440431156 -1.3909 0.7019988941236912 0.7019973907344093 -5.03201609498849e-07 -0.09712055678981737 -1.391 0.7020004243217272 0.7019989308084986 -5.056044491205669e-07 -0.09712141892088905 -1.3911000000000002 0.7020019540391211 0.7020004704506726 -5.079013445444258e-07 -0.09712228079759949 -1.3912 0.7020034832771415 0.7020020096599284 -5.100918028938528e-07 -0.09712314242002153 -1.3913000000000002 0.7020050120370611 0.7020035484352578 -5.12175355689426e-07 -0.09712400378822783 -1.3914000000000002 0.7020065403201585 0.7020050867756477 -5.141515588766299e-07 -0.09712486490229122 -1.3915 0.7020080681277157 0.7020066246800805 -5.16019992943817e-07 -0.09712572576228436 -1.3916000000000002 0.7020095954610193 0.7020081621475345 -5.177802630332295e-07 -0.09712658636827999 -1.3917 0.7020111223213601 0.7020096991769844 -5.194319989687557e-07 -0.09712744672035084 -1.3918000000000001 0.7020126487100318 0.7020112357674008 -5.209748553530735e-07 -0.09712830681856953 -1.3919000000000001 0.7020141746283319 0.7020127719177507 -5.224085116717347e-07 -0.09712916666300872 -1.392 0.7020157000775609 0.7020143076269986 -5.237326723486757e-07 -0.09713002625374104 -1.3921000000000001 0.7020172250590223 0.7020158428941055 -5.249470667462175e-07 -0.09713088559083913 -1.3922 0.702018749574022 0.70201737771803 -5.260514493107826e-07 -0.09713174467437559 -1.3923 0.7020202736238682 0.7020189120977284 -5.270455995590173e-07 -0.09713260350442304 -1.3924 0.7020217972098709 0.7020204460321546 -5.279293221818748e-07 -0.09713346208105392 -1.3925 0.7020233203333421 0.7020219795202611 -5.287024469891044e-07 -0.09713432040434086 -1.3926 0.7020248429955955 0.7020235125609986 -5.293648290272124e-07 -0.09713517847435636 -1.3927 0.7020263651979455 0.7020250451533168 -5.2991634853089e-07 -0.0971360362911729 -1.3928000000000003 0.7020278869417078 0.7020265772961636 -5.30356911075669e-07 -0.09713689385486296 -1.3929 0.7020294082281985 0.7020281089884869 -5.30686447418327e-07 -0.097137751165499 -1.393 0.7020309290587344 0.7020296402292341 -5.309049136079103e-07 -0.09713860822315348 -1.3931000000000002 0.7020324494346324 0.7020311710173521 -5.310122909718551e-07 -0.0971394650278988 -1.3932 0.7020339693572091 0.7020327013517876 -5.310085861298663e-07 -0.09714032157980733 -1.3933000000000002 0.7020354888277806 0.7020342312314884 -5.308938309869782e-07 -0.09714117787895148 -1.3934000000000002 0.7020370078476628 0.7020357606554024 -5.306680826294707e-07 -0.09714203392540363 -1.3935 0.7020385264181702 0.7020372896224785 -5.303314234497702e-07 -0.09714288971923613 -1.3936000000000002 0.7020400445406163 0.7020388181316667 -5.298839610007322e-07 -0.09714374526052125 -1.3937 0.702041562216313 0.7020403461819182 -5.293258280164581e-07 -0.09714460054933134 -1.3938000000000001 0.7020430794465704 0.7020418737721864 -5.286571824053565e-07 -0.09714545558573867 -1.3939000000000001 0.7020445962326973 0.7020434009014261 -5.27878207125243e-07 -0.09714631036981557 -1.394 0.7020461125759991 0.7020449275685945 -5.269891102041568e-07 -0.09714716490163415 -1.3941000000000001 0.7020476284777792 0.7020464537726512 -5.25990124670972e-07 -0.0971480191812667 -1.3942 0.7020491439393384 0.7020479795125589 -5.248815084721303e-07 -0.09714887320878551 -1.3943 0.7020506589619742 0.7020495047872832 -5.236635444369475e-07 -0.0971497269842627 -1.3944 0.7020521735469804 0.7020510295957927 -5.223365402082236e-07 -0.09715058050777042 -1.3945 0.7020536876956478 0.7020525539370592 -5.209008280826488e-07 -0.09715143377938082 -1.3946 0.7020552014092631 0.7020540778100592 -5.193567650385589e-07 -0.0971522867991661 -1.3947 0.7020567146891088 0.7020556012137729 -5.177047325971573e-07 -0.09715313956719829 -1.3948000000000003 0.7020582275364626 0.7020571241471841 -5.159451368225154e-07 -0.09715399208354947 -1.3949 0.7020597399525986 0.7020586466092824 -5.140784079815663e-07 -0.09715484434829176 -1.395 0.7020612519387852 0.7020601685990615 -5.12105000689822e-07 -0.09715569636149723 -1.3951000000000002 0.7020627634962857 0.7020616901155204 -5.100253936685117e-07 -0.09715654812323787 -1.3952 0.702064274626358 0.7020632111576632 -5.078400897098878e-07 -0.09715739963358572 -1.3953000000000002 0.7020657853302545 0.7020647317245001 -5.055496154898753e-07 -0.09715825089261276 -1.3954000000000002 0.7020672956092218 0.7020662518150468 -5.031545214362332e-07 -0.09715910190039095 -1.3955 0.7020688054644998 0.7020677714283249 -5.00655381673043e-07 -0.09715995265699229 -1.3956000000000002 0.7020703148973222 0.702069290563363 -4.980527938541757e-07 -0.09716080316248868 -1.3957 0.7020718239089164 0.7020708092191957 -4.953473789343077e-07 -0.0971616534169521 -1.3958000000000002 0.7020733325005022 0.7020723273948648 -4.925397810925936e-07 -0.09716250342045435 -1.3959000000000001 0.7020748406732926 0.7020738450894191 -4.896306676632767e-07 -0.09716335317306736 -1.396 0.7020763484284933 0.7020753623019147 -4.86620728774867e-07 -0.09716420267486298 -1.3961000000000001 0.7020778557673021 0.7020768790314156 -4.835106773917741e-07 -0.09716505192591311 -1.3962 0.7020793626909088 0.7020783952769931 -4.803012490575687e-07 -0.09716590092628946 -1.3963 0.7020808692004953 0.702079911037727 -4.769932016729372e-07 -0.09716674967606388 -1.3964 0.7020823752972352 0.7020814263127055 -4.7358731538466037e-07 -0.09716759817530822 -1.3965 0.7020838809822929 0.7020829411010248 -4.7008439241214006e-07 -0.09716844642409415 -1.3966 0.7020853862568249 0.7020844554017902 -4.664852567837219e-07 -0.09716929442249346 -1.3967 0.702086891121978 0.7020859692141164 -4.6279075419097815e-07 -0.0971701421705779 -1.3968000000000003 0.7020883955788892 0.7020874825371266 -4.59001751856869e-07 -0.09717098966841912 -1.3969 0.7020898996286872 0.7020889953699538 -4.5511913820961425e-07 -0.09717183691608886 -1.397 0.7020914032724899 0.7020905077117408 -4.5114382273003795e-07 -0.0971726839136587 -1.3971000000000002 0.7020929065114057 0.70209201956164 -4.4707673575727913e-07 -0.09717353066120038 -1.3972 0.7020944093465328 0.7020935309188145 -4.4291882824593065e-07 -0.0971743771587855 -1.3973000000000002 0.7020959117789587 0.7020950417824373 -4.3867107153705565e-07 -0.09717522340648566 -1.3974000000000002 0.7020974138097605 0.7020965521516919 -4.34334457198593e-07 -0.09717606940437246 -1.3975 0.7020989154400044 0.7020980620257727 -4.2990999667147367e-07 -0.09717691515251745 -1.3976000000000002 0.7021004166707454 0.7020995714038855 -4.253987211239041e-07 -0.09717776065099222 -1.3977 0.7021019175030276 0.7021010802852463 -4.2080168126401585e-07 -0.09717860589986826 -1.3978000000000002 0.7021034179378833 0.7021025886690835 -4.1611994692353216e-07 -0.09717945089921712 -1.3979000000000001 0.7021049179763332 0.7021040965546366 -4.113546069536844e-07 -0.09718029564911028 -1.398 0.7021064176193863 0.7021056039411571 -4.065067689407176e-07 -0.09718114014961925 -1.3981000000000001 0.7021079168680391 0.7021071108279082 -4.0157755891445657e-07 -0.0971819844008154 -1.3982 0.7021094157232765 0.7021086172141654 -3.9656812109156725e-07 -0.09718282840277026 -1.3983 0.7021109141860702 0.7021101230992168 -3.9147961770208406e-07 -0.09718367215555515 -1.3984 0.7021124122573797 0.702111628482363 -3.8631322857307637e-07 -0.09718451565924154 -1.3985 0.7021139099381519 0.7021131333629173 -3.810701509204817e-07 -0.09718535891390082 -1.3986 0.7021154072293203 0.7021146377402057 -3.757515991478777e-07 -0.09718620191960431 -1.3987 0.7021169041318049 0.7021161416135677 -3.7035880445096536e-07 -0.09718704467642336 -1.3988000000000003 0.7021184006465133 0.702117644982356 -3.648930145747076e-07 -0.09718788718442929 -1.3989 0.7021198967743388 0.7021191478459365 -3.5935549353577345e-07 -0.09718872944369343 -1.399 0.7021213925161613 0.702120650203689 -3.5374752133804366e-07 -0.09718957145428704 -1.3991000000000002 0.7021228878728465 0.702122152055007 -3.480703936534213e-07 -0.09719041321628141 -1.3992 0.7021243828452464 0.702123653399298 -3.4232542153039835e-07 -0.09719125472974771 -1.3993000000000002 0.7021258774341987 0.7021251542359839 -3.3651393110956107e-07 -0.09719209599475727 -1.3994000000000002 0.7021273716405267 0.7021266545645002 -3.3063726322807296e-07 -0.09719293701138124 -1.3995 0.7021288654650393 0.7021281543842974 -3.2469677330171365e-07 -0.0971937777796908 -1.3996000000000002 0.7021303589085306 0.7021296536948405 -3.186938308044618e-07 -0.09719461829975712 -1.3997 0.7021318519717801 0.7021311524956091 -3.1262981909502274e-07 -0.0971954585716514 -1.3998000000000002 0.702133344655552 0.7021326507860979 -3.0650613501437274e-07 -0.09719629859544474 -1.3999000000000001 0.7021348369605958 0.7021341485658161 -3.003241885943253e-07 -0.09719713837120823 -1.4 0.7021363288876453 0.7021356458342889 -2.940854027556894e-07 -0.097197977899013 -1.4001000000000001 0.7021378204374196 0.7021371425910559 -2.8779121295785526e-07 -0.09719881717893009 -1.4002000000000001 0.7021393116106216 0.7021386388356728 -2.814430668587886e-07 -0.09719965621103056 -1.4003 0.702140802407939 0.7021401345677105 -2.750424240270666e-07 -0.09720049499538545 -1.4004 0.7021422928300437 0.7021416297867558 -2.685907555186051e-07 -0.09720133353206578 -1.4005 0.7021437828775916 0.7021431244924108 -2.6208954364767556e-07 -0.09720217182114252 -1.4006 0.7021452725512229 0.702144618684294 -2.555402815601626e-07 -0.09720300986268669 -1.4007 0.7021467618515616 0.70214611236204 -2.489444729456003e-07 -0.09720384765676926 -1.4008000000000003 0.7021482507792152 0.7021476055252992 -2.423036316624716e-07 -0.09720468520346114 -1.4009 0.7021497393347753 0.7021490981737379 -2.356192814016722e-07 -0.09720552250283321 -1.401 0.7021512275188171 0.7021505903070397 -2.2889295530834075e-07 -0.09720635955495645 -1.4011000000000002 0.7021527153318985 0.7021520819249039 -2.2212619570777248e-07 -0.09720719635990166 -1.4012 0.702154202774562 0.7021535730270465 -2.1532055365786062e-07 -0.09720803291773977 -1.4013000000000002 0.7021556898473328 0.7021550636132 -2.0847758865766286e-07 -0.0972088692285416 -1.4014000000000002 0.7021571765507194 0.7021565536831138 -2.0159886827270102e-07 -0.09720970529237802 -1.4015 0.7021586628852137 0.702158043236554 -1.9468596773944413e-07 -0.09721054110931979 -1.4016000000000002 0.70216014885129 0.7021595322733034 -1.8774046969122216e-07 -0.09721137667943769 -1.4017 0.7021616344494059 0.702161020793162 -1.8076396370372838e-07 -0.0972122120028025 -1.4018000000000002 0.7021631196800026 0.7021625087959467 -1.73758045965422e-07 -0.09721304707948497 -1.4019000000000001 0.7021646045435033 0.7021639962814914 -1.6672431896354312e-07 -0.09721388190955586 -1.402 0.7021660890403141 0.702165483249647 -1.5966439103308472e-07 -0.09721471649308581 -1.4021000000000001 0.7021675731708241 0.7021669697002819 -1.5257987603066459e-07 -0.09721555083014555 -1.4022000000000001 0.7021690569354058 0.7021684556332818 -1.454723929702334e-07 -0.09721638492080581 -1.4023 0.7021705403344125 0.7021699410485489 -1.383435656501092e-07 -0.09721721876513713 -1.4024 0.7021720233681819 0.7021714259460039 -1.3119502226439927e-07 -0.09721805236321024 -1.4025 0.7021735060370332 0.7021729103255842 -1.2402839506819863e-07 -0.09721888571509574 -1.4026 0.7021749883412686 0.7021743941872443 -1.1684531996299097e-07 -0.09721971882086416 -1.4027 0.7021764702811726 0.702175877530957 -1.0964743614103045e-07 -0.09722055168058619 -1.4028000000000003 0.7021779518570117 0.7021773603567121 -1.0243638573492753e-07 -0.0972213842943323 -1.4029 0.7021794330690359 0.702178842664517 -9.521381339177432e-08 -0.09722221666217305 -1.403 0.7021809139174764 0.7021803244543966 -8.798136594354716e-08 -0.097223048784179 -1.4031000000000002 0.7021823944025477 0.7021818057263932 -8.074069201245704e-08 -0.0972238806604206 -1.4032 0.7021838745244462 0.7021832864805673 -7.349344164318816e-08 -0.09722471229096841 -1.4033000000000002 0.7021853542833506 0.702184766716996 -6.624126591215154e-08 -0.09722554367589283 -1.4034 0.7021868336794223 0.7021862464357751 -5.8985816567963534e-08 -0.09722637481526436 -1.4035 0.7021883127128044 0.7021877256370166 -5.172874564937299e-08 -0.09722720570915334 -1.4036000000000002 0.702189791383623 0.7021892043208515 -4.447170510709156e-08 -0.09722803635763023 -1.4037 0.7021912696919863 0.7021906824874273 -3.7216346427765236e-08 -0.09722886676076539 -1.4038000000000002 0.7021927476379849 0.7021921601369101 -2.996432026114437e-08 -0.09722969691862926 -1.4039000000000001 0.7021942252216915 0.7021936372694828 -2.271727604554602e-08 -0.09723052683129213 -1.404 0.7021957024431617 0.702195113885346 -1.5476861625618454e-08 -0.09723135649882435 -1.4041000000000001 0.7021971793024329 0.7021965899847177 -8.244722887913725e-09 -0.09723218592129623 -1.4042000000000001 0.7021986557995251 0.7021980655678339 -1.0225033788419102e-09 -0.09723301509877803 -1.4043 0.7022001319344414 0.7021995406349475 6.188156065692341e-09 -0.0972338440313401 -1.4044 0.7022016077071667 0.7022010151863289 1.338561768891855e-08 -0.09723467271905263 -1.4045 0.7022030831176687 0.7022024892222665 2.056824719397221e-08 -0.09723550116198588 -1.4046 0.7022045581658973 0.7022039627430654 2.7734414114258255e-08 -0.0972363293602101 -1.4047 0.7022060328517858 0.7022054357490484 3.488249217080408e-08 -0.09723715731379551 -1.4048000000000003 0.7022075071752495 0.7022069082405548 4.201085965042928e-08 -0.09723798502281215 -1.4049 0.7022089811361865 0.7022083802179424 4.911789977871117e-08 -0.09723881248733032 -1.405 0.7022104547344776 0.7022098516815851 5.620200108601148e-08 -0.09723963970742015 -1.4051000000000002 0.702211927969987 0.7022113226318744 6.326155775268627e-08 -0.09724046668315167 -1.4052 0.7022134008425612 0.7022127930692185 7.02949699941946e-08 -0.09724129341459507 -1.4053000000000002 0.7022148733520299 0.702214262994043 7.730064442712514e-08 -0.09724211990182044 -1.4054 0.7022163454982062 0.7022157324067899 8.427699441093672e-08 -0.09724294614489781 -1.4055 0.7022178172808855 0.7022172013079182 9.122244042092387e-08 -0.09724377214389723 -1.4056000000000002 0.7022192886998471 0.7022186696979038 9.813541039169205e-08 -0.09724459789888878 -1.4057 0.7022207597548532 0.7022201375772388 1.0501434010226629e-07 -0.09724542340994237 -1.4058000000000002 0.7022222304456497 0.7022216049464324 1.1185767348834141e-07 -0.09724624867712808 -1.4059000000000001 0.7022237007719656 0.7022230718060101 1.1866386302739063e-07 -0.09724707370051587 -1.406 0.7022251707335139 0.7022245381565133 1.2543137007173244e-07 -0.09724789848017568 -1.4061000000000001 0.7022266403299908 0.7022260039985004 1.3215866521629205e-07 -0.09724872301617743 -1.4062000000000001 0.7022281095610765 0.7022274693325458 1.3884422862472934e-07 -0.09724954730859107 -1.4063 0.7022295784264352 0.7022289341592394 1.4548655037638358e-07 -0.09725037135748649 -1.4064 0.7022310469257145 0.7022303984791876 1.520841308097487e-07 -0.09725119516293354 -1.4065 0.7022325150585464 0.7022318622930124 1.5863548085554013e-07 -0.0972520187250021 -1.4066 0.702233982824548 0.7022333256013518 1.651391223767007e-07 -0.09725284204376201 -1.4067 0.7022354502233192 0.702234788404859 1.71593588497998e-07 -0.09725366511928313 -1.4068000000000003 0.7022369172544454 0.702236250704203 1.779974239807247e-07 -0.0972544879516352 -1.4069 0.7022383839174962 0.7022377125000682 1.8434918544821266e-07 -0.09725531054088804 -1.407 0.7022398502120255 0.7022391737931538 1.90647441829922e-07 -0.09725613288711141 -1.4071000000000002 0.7022413161375732 0.7022406345841747 1.9689077459389415e-07 -0.09725695499037508 -1.4072 0.7022427816936632 0.7022420948738601 2.030777781214521e-07 -0.09725777685074875 -1.4073000000000002 0.7022442468798049 0.7022435546629544 2.0920705999516453e-07 -0.09725859846830219 -1.4074 0.7022457116954925 0.7022450139522165 2.1527724132150428e-07 -0.09725941984310499 -1.4075 0.7022471761402064 0.7022464727424198 2.2128695702922085e-07 -0.09726024097522684 -1.4076000000000002 0.7022486402134119 0.7022479310343522 2.2723485622322404e-07 -0.09726106186473744 -1.4077 0.7022501039145607 0.7022493888288159 2.3311960237887286e-07 -0.09726188251170645 -1.4078000000000002 0.7022515672430896 0.7022508461266271 2.389398737895343e-07 -0.09726270291620347 -1.4079000000000002 0.7022530301984217 0.7022523029286156 2.4469436375046394e-07 -0.09726352307829805 -1.408 0.7022544927799665 0.7022537592356253 2.503817808988118e-07 -0.0972643429980598 -1.4081000000000001 0.7022559549871199 0.702255215048513 2.560008494773003e-07 -0.09726516267555824 -1.4082000000000001 0.7022574168192639 0.7022566703681496 2.615503096811689e-07 -0.09726598211086293 -1.4083 0.7022588782757679 0.7022581251954194 2.670289178385854e-07 -0.09726680130404347 -1.4084 0.7022603393559876 0.7022595795312191 2.7243544682004073e-07 -0.09726762025516927 -1.4085 0.7022618000592661 0.7022610333764584 2.777686861910045e-07 -0.0972684389643099 -1.4086 0.7022632603849333 0.7022624867320596 2.830274425658086e-07 -0.0972692574315347 -1.4087 0.7022647203323071 0.702263939598958 2.8821053980193634e-07 -0.09727007565691323 -1.4088000000000003 0.7022661799006928 0.7022653919781007 2.933168193122726e-07 -0.09727089364051483 -1.4089 0.7022676390893836 0.7022668438704471 2.983451403426596e-07 -0.097271711382409 -1.409 0.7022690978976605 0.7022682952769685 3.032943801870025e-07 -0.09727252888266509 -1.4091000000000002 0.7022705563247926 0.702269746198648 3.081634344578865e-07 -0.09727334614135248 -1.4092 0.7022720143700381 0.7022711966364801 3.129512173086213e-07 -0.09727416315854052 -1.4093000000000002 0.7022734720326428 0.7022726465914708 3.17656661696919e-07 -0.09727497993429857 -1.4094 0.7022749293118418 0.702274096064637 3.2227871960693877e-07 -0.09727579646869583 -1.4095 0.7022763862068594 0.7022755450570068 3.2681636229908717e-07 -0.09727661276180175 -1.4096000000000002 0.7022778427169091 0.7022769935696189 3.312685805598181e-07 -0.09727742881368555 -1.4097 0.7022792988411934 0.7022784416035222 3.35634384895922e-07 -0.09727824462441646 -1.4098000000000002 0.7022807545789048 0.7022798891597766 3.399128057079981e-07 -0.09727906019406381 -1.4099000000000002 0.7022822099292255 0.7022813362394509 3.4410289359576574e-07 -0.0972798755226967 -1.41 0.702283664891328 0.7022827828436251 3.4820371952459794e-07 -0.09728069061038441 -1.4101000000000001 0.7022851194643747 0.702284228973388 3.522143750614437e-07 -0.09728150545719613 -1.4102000000000001 0.702286573647519 0.702285674629838 3.561339724997281e-07 -0.09728232006320103 -1.4103 0.7022880274399047 0.7022871198140829 3.599616451299692e-07 -0.0972831344284682 -1.4104 0.7022894808406666 0.7022885645272391 3.636965474063114e-07 -0.09728394855306685 -1.4105 0.7022909338489307 0.7022900087704318 3.6733785514081463e-07 -0.09728476243706603 -1.4106 0.7022923864638143 0.7022914525447952 3.708847656977432e-07 -0.09728557608053483 -1.4107 0.7022938386844266 0.7022928958514709 3.7433649809071046e-07 -0.0972863894835423 -1.4108000000000003 0.7022952905098689 0.7022943386916096 3.7769229326023446e-07 -0.09728720264615759 -1.4109 0.7022967419392343 0.702295781066369 3.809514142125159e-07 -0.09728801556844972 -1.411 0.7022981929716081 0.7022972229769144 3.8411314610270475e-07 -0.09728882825048765 -1.4111000000000002 0.7022996436060684 0.7022986644244189 3.8717679652633397e-07 -0.09728964069234038 -1.4112 0.7023010938416865 0.7023001054100626 3.901416955609527e-07 -0.097290452894077 -1.4113000000000002 0.7023025436775258 0.7023015459350318 3.9300719593959865e-07 -0.0972912648557663 -1.4114 0.702303993112644 0.7023029860005201 3.9577267322427057e-07 -0.09729207657747733 -1.4115 0.7023054421460921 0.7023044256077273 3.984375258961337e-07 -0.097292888059279 -1.4116000000000002 0.7023068907769149 0.7023058647578593 4.0100117552899217e-07 -0.09729369930124022 -1.4117 0.702308339004151 0.7023073034521277 4.034630669072503e-07 -0.0972945103034299 -1.4118000000000002 0.7023097868268335 0.7023087416917498 4.05822668123057e-07 -0.09729532106591687 -1.4119000000000002 0.7023112342439903 0.7023101794779486 4.080794706526336e-07 -0.09729613158877001 -1.412 0.7023126812546436 0.7023116168119516 4.10232989613013e-07 -0.0972969418720581 -1.4121000000000001 0.7023141278578113 0.7023130536949913 4.122827636787729e-07 -0.09729775191585 -1.4122000000000001 0.7023155740525062 0.7023144901283054 4.142283553248971e-07 -0.0972985617202145 -1.4123 0.7023170198377366 0.7023159261131353 4.1606935082677543e-07 -0.09729937128522037 -1.4124 0.7023184652125071 0.7023173616507268 4.1780536040592064e-07 -0.09730018061093637 -1.4125 0.7023199101758177 0.7023187967423297 4.194360183062962e-07 -0.09730098969743124 -1.4126 0.7023213547266653 0.7023202313891969 4.209609828290106e-07 -0.09730179854477371 -1.4127 0.7023227988640436 0.7023216655925847 4.223799364710956e-07 -0.09730260715303245 -1.4128000000000003 0.7023242425869423 0.7023230993537527 4.2369258589775027e-07 -0.09730341552227612 -1.4129 0.702325685894349 0.7023245326739638 4.248986621158135e-07 -0.09730422365257348 -1.413 0.7023271287852485 0.7023259655544823 4.259979204251918e-07 -0.09730503154399317 -1.4131000000000002 0.7023285712586229 0.7023273979965758 4.269901405090648e-07 -0.09730583919660374 -1.4132 0.7023300133134526 0.7023288300015131 4.278751265171521e-07 -0.09730664661047382 -1.4133000000000002 0.7023314549487156 0.7023302615705656 4.2865270704489644e-07 -0.09730745378567197 -1.4134 0.7023328961633893 0.7023316927050056 4.2932273516815833e-07 -0.09730826072226686 -1.4135 0.7023343369564492 0.7023331234061072 4.2988508852648266e-07 -0.09730906742032702 -1.4136000000000002 0.7023357773268692 0.7023345536751446 4.3033966930922096e-07 -0.0973098738799209 -1.4137 0.7023372172736235 0.7023359835133934 4.306864042347147e-07 -0.09731068010111708 -1.4138000000000002 0.7023386567956853 0.7023374129221298 4.309252445849898e-07 -0.09731148608398406 -1.4139000000000002 0.7023400958920272 0.7023388419026296 4.3105616627514554e-07 -0.09731229182859033 -1.414 0.7023415345616222 0.702340270456169 4.3107916975620997e-07 -0.09731309733500432 -1.4141000000000001 0.7023429728034436 0.7023416985840234 4.309942800984068e-07 -0.09731390260329448 -1.4142000000000001 0.7023444106164648 0.7023431262874683 4.308015468454385e-07 -0.09731470763352924 -1.4143000000000001 0.7023458479996605 0.7023445535677779 4.3050104416020307e-07 -0.09731551242577705 -1.4144 0.7023472849520058 0.7023459804262253 4.3009287065132185e-07 -0.0973163169801062 -1.4145 0.7023487214724778 0.702347406864082 4.295771494911005e-07 -0.09731712129658515 -1.4146 0.702350157560055 0.7023488328826186 4.2895402824899564e-07 -0.0973179253752822 -1.4147 0.7023515932137174 0.7023502584831031 4.282236789332483e-07 -0.09731872921626572 -1.4148000000000003 0.7023530284324473 0.7023516836668016 4.273862978868004e-07 -0.09731953281960395 -1.4149 0.7023544632152292 0.7023531084349776 4.264421057595391e-07 -0.09732033618536524 -1.415 0.7023558975610505 0.7023545327888923 4.2539134757074715e-07 -0.09732113931361785 -1.4151000000000002 0.7023573314689013 0.7023559567298038 4.242342923968523e-07 -0.09732194220443008 -1.4152 0.7023587649377748 0.7023573802589669 4.229712335032665e-07 -0.09732274485787012 -1.4153000000000002 0.7023601979666677 0.7023588033776329 4.2160248821254687e-07 -0.09732354727400622 -1.4154 0.7023616305545801 0.7023602260870497 4.2012839777255673e-07 -0.09732434945290656 -1.4155 0.7023630627005162 0.702361648388461 4.185493274119767e-07 -0.09732515139463936 -1.4156000000000002 0.7023644944034841 0.7023630702831065 4.1686566609050457e-07 -0.09732595309927278 -1.4157 0.7023659256624966 0.7023644917722212 4.150778264919164e-07 -0.09732675456687495 -1.4158000000000002 0.7023673564765709 0.7023659128570354 4.13186244919983e-07 -0.097327555797514 -1.4159000000000002 0.7023687868447297 0.7023673335387746 4.11191381180509e-07 -0.09732835679125806 -1.416 0.7023702167659996 0.7023687538186587 4.0909371841479913e-07 -0.09732915754817519 -1.4161000000000001 0.7023716462394138 0.7023701736979024 4.068937630996583e-07 -0.09732995806833349 -1.4162000000000001 0.7023730752640106 0.7023715931777151 4.045920448669804e-07 -0.09733075835180095 -1.4163000000000001 0.7023745038388343 0.7023730122592995 4.021891163094593e-07 -0.09733155839864567 -1.4164 0.7023759319629354 0.7023744309438527 3.9968555293895536e-07 -0.09733235820893571 -1.4165 0.7023773596353704 0.702375849232565 3.97081953089351e-07 -0.09733315778273899 -1.4166 0.7023787868552032 0.7023772671266202 3.9437893759042275e-07 -0.09733395712012353 -1.4167 0.7023802136215034 0.7023786846271949 3.9157714980947445e-07 -0.0973347562211573 -1.4168000000000003 0.7023816399333489 0.7023801017354591 3.8867725542929277e-07 -0.09733555508590824 -1.4169 0.7023830657898242 0.7023815184525746 3.8567994226079705e-07 -0.09733635371444425 -1.417 0.7023844911900217 0.7023829347796963 3.8258592013895587e-07 -0.0973371521068333 -1.4171 0.7023859161330408 0.7023843507179709 3.793959206799258e-07 -0.09733795026314321 -1.4172 0.7023873406179904 0.7023857662685369 3.761106971492123e-07 -0.09733874818344189 -1.4173000000000002 0.7023887646439865 0.7023871814325247 3.7273102435758654e-07 -0.0973395458677972 -1.4174 0.7023901882101539 0.7023885962110559 3.6925769832801825e-07 -0.09734034331627694 -1.4175 0.702391611315626 0.7023900106052439 3.656915362262869e-07 -0.09734114052894896 -1.4176000000000002 0.7023930339595454 0.7023914246161922 3.620333761111816e-07 -0.09734193750588103 -1.4177 0.7023944561410639 0.7023928382449958 3.5828407678878404e-07 -0.09734273424714096 -1.4178000000000002 0.7023958778593422 0.7023942514927398 3.544445175765465e-07 -0.0973435307527965 -1.4179000000000002 0.702397299113551 0.7023956643605 3.505155980604302e-07 -0.09734432702291539 -1.418 0.7023987199028705 0.7023970768493424 3.4649823797000545e-07 -0.09734512305756535 -1.4181000000000001 0.7024001402264912 0.7023984889603223 3.42393376887018e-07 -0.09734591885681407 -1.4182000000000001 0.702401560083614 0.7023999006944854 3.3820197405803887e-07 -0.0973467144207293 -1.4183000000000001 0.7024029794734494 0.7024013120528667 3.3392500820711435e-07 -0.09734750974937867 -1.4184 0.7024043983952195 0.70240272303649 3.295634772512712e-07 -0.09734830484282982 -1.4185 0.7024058168481564 0.7024041336463689 3.251183980854111e-07 -0.09734909970115037 -1.4186 0.7024072348315042 0.7024055438835056 3.2059080633944914e-07 -0.09734989432440802 -1.4187 0.7024086523445173 0.7024069537488908 3.15981756121575e-07 -0.09735068871267027 -1.4188000000000003 0.7024100693864622 0.7024083632435041 3.112923198864137e-07 -0.09735148286600476 -1.4189 0.7024114859566165 0.7024097723683131 3.065235879978756e-07 -0.09735227678447904 -1.419 0.70241290205427 0.7024111811242734 3.016766686389505e-07 -0.0973530704681606 -1.4191 0.7024143176787243 0.702412589512329 2.967526874717019e-07 -0.09735386391711703 -1.4192 0.7024157328292933 0.7024139975334114 2.917527874013448e-07 -0.09735465713141582 -1.4193000000000002 0.702417147505303 0.7024154051884395 2.866781282639952e-07 -0.09735545011112443 -1.4194 0.7024185617060925 0.7024168124783199 2.815298866393201e-07 -0.09735624285631037 -1.4195 0.7024199754310131 0.7024182194039462 2.7630925551053176e-07 -0.09735703536704103 -1.4196000000000002 0.7024213886794293 0.7024196259661992 2.7101744406315964e-07 -0.09735782764338395 -1.4197 0.7024228014507179 0.7024210321659464 2.656556773381058e-07 -0.09735861968540642 -1.4198000000000002 0.7024242137442702 0.7024224380040422 2.6022519591939464e-07 -0.0973594114931759 -1.4199000000000002 0.7024256255594898 0.7024238434813275 2.5472725576070054e-07 -0.09736020306675978 -1.42 0.7024270368957946 0.7024252485986293 2.4916312778289207e-07 -0.09736099440622542 -1.4201000000000001 0.7024284477526156 0.7024266533567611 2.435340976658651e-07 -0.0973617855116401 -1.4202000000000001 0.702429858129398 0.7024280577565226 2.3784146543914808e-07 -0.09736257638307119 -1.4203000000000001 0.7024312680256009 0.702429461798699 2.3208654535700202e-07 -0.09736336702058597 -1.4204 0.7024326774406975 0.7024308654840619 2.2627066544045338e-07 -0.09736415742425178 -1.4205 0.7024340863741756 0.7024322688133677 2.2039516723443286e-07 -0.09736494759413583 -1.4206 0.7024354948255372 0.7024336717873592 2.144614054747085e-07 -0.09736573753030542 -1.4207 0.7024369027942989 0.7024350744067638 2.084707478172687e-07 -0.09736652723282775 -1.4208000000000003 0.7024383102799918 0.7024364766722946 2.0242457447056106e-07 -0.09736731670177004 -1.4209 0.7024397172821621 0.7024378785846496 1.963242779040586e-07 -0.09736810593719947 -1.421 0.7024411238003709 0.7024392801445116 1.9017126256376526e-07 -0.09736889493918321 -1.4211 0.7024425298341945 0.7024406813525489 1.8396694447322948e-07 -0.09736968370778848 -1.4212 0.7024439353832244 0.7024420822094136 1.7771275094558003e-07 -0.09737047224308233 -1.4213000000000002 0.7024453404470672 0.7024434827157432 1.7141012027821478e-07 -0.09737126054513201 -1.4214 0.7024467450253451 0.702444882872159 1.6506050139891704e-07 -0.0973720486140045 -1.4215 0.7024481491176959 0.7024462826792675 1.586653535293192e-07 -0.097372836449767 -1.4216000000000002 0.702449552723773 0.7024476821376585 1.522261458587748e-07 -0.0973736240524865 -1.4217 0.7024509558432454 0.7024490812479067 1.4574435718353596e-07 -0.09737441142223004 -1.4218000000000002 0.7024523584757982 0.7024504800105706 1.3922147562225873e-07 -0.09737519855906468 -1.4219000000000002 0.7024537606211324 0.7024518784261929 1.326589982204862e-07 -0.09737598546305745 -1.422 0.702455162278965 0.7024532764952998 1.2605843062105104e-07 -0.09737677213427533 -1.4221000000000001 0.7024565634490292 0.7024546742184015 1.194212867240696e-07 -0.09737755857278525 -1.4222000000000001 0.7024579641310743 0.702456071595992 1.1274908836081399e-07 -0.09737834477865426 -1.4223000000000001 0.702459364324866 0.702457468628549 1.0604336490166455e-07 -0.09737913075194929 -1.4224 0.7024607640301863 0.7024588653165337 9.930565294039018e-08 -0.09737991649273724 -1.4225 0.7024621632468335 0.7024602616603903 9.253749592638694e-08 -0.09738070200108495 -1.4226 0.7024635619746229 0.7024616576605471 8.574044381773338e-08 -0.09738148727705938 -1.4227 0.7024649602133859 0.7024630533174154 7.891605272036806e-08 -0.09738227232072738 -1.4228000000000003 0.7024663579629706 0.7024644486313898 7.206588452900176e-08 -0.09738305713215578 -1.4229 0.7024677552232421 0.7024658436028482 6.519150658884643e-08 -0.09738384171141146 -1.423 0.7024691519940822 0.702467238232152 5.829449131744546e-08 -0.09738462605856123 -1.4231 0.702470548275389 0.7024686325196453 5.137641584558594e-08 -0.09738541017367186 -1.4232 0.7024719440670782 0.702470026465655 4.4438861682497e-08 -0.09738619405681015 -1.4233000000000002 0.7024733393690816 0.7024714200704916 3.748341431859814e-08 -0.09738697770804278 -1.4234 0.7024747341813489 0.7024728133344486 3.051166288549345e-08 -0.09738776112743659 -1.4235 0.7024761285038456 0.7024742062578022 2.3525199781271322e-08 -0.09738854431505825 -1.4236000000000002 0.7024775223365551 0.7024755988408117 1.6525620320957668e-08 -0.09738932727097453 -1.4237 0.7024789156794776 0.702476991083719 9.514522365285105e-09 -0.09739010999525204 -1.4238000000000002 0.7024803085326301 0.7024783829867494 2.4935059520642122e-09 -0.09739089248795746 -1.4239000000000002 0.702481700896047 0.7024797745501108 -4.535827067241038e-09 -0.09739167474915753 -1.424 0.7024830927697796 0.7024811657739938 -1.1571873390070486e-08 -0.09739245677891879 -1.4241000000000001 0.7024844841538962 0.702482556658572 -1.86130286296618e-08 -0.09739323857730789 -1.4242000000000001 0.7024858750484824 0.7024839472040016 -2.565768767890872e-08 -0.09739402014439141 -1.4243000000000001 0.7024872654536408 0.7024853374104224 -3.270424508029085e-08 -0.09739480148023594 -1.4244 0.7024886553694911 0.7024867272779561 -3.975109538940664e-08 -0.09739558258490806 -1.4245 0.7024900447961702 0.7024881168067076 -4.6796633538858734e-08 -0.09739636345847429 -1.4246 0.7024914337338317 0.702489505996765 -5.383925520663878e-08 -0.09739714410100114 -1.4247 0.702492822182647 0.7024908948481985 -6.087735717960618e-08 -0.09739792451255516 -1.4248000000000003 0.7024942101428038 0.7024922833610616 -6.790933771870164e-08 -0.09739870469320279 -1.4249 0.7024955976145075 0.702493671535391 -7.493359692337456e-08 -0.09739948464301058 -1.425 0.7024969845979802 0.7024950593712058 -8.194853709595634e-08 -0.09740026436204494 -1.4251 0.7024983710934605 0.7024964468685082 -8.895256310443439e-08 -0.09740104385037224 -1.4252 0.7024997571012048 0.7024978340272835 -9.594408274891247e-08 -0.09740182310805898 -1.4253000000000002 0.702501142621486 0.7024992208474999 -1.0292150711202486e-07 -0.09740260213517153 -1.4254 0.702502527654594 0.7025006073291089 -1.0988325093667234e-07 -0.0974033809317763 -1.4255 0.7025039122008354 0.7025019934720445 -1.1682773297383431e-07 -0.09740415949793961 -1.4256000000000002 0.7025052962605336 0.7025033792762243 -1.2375337633992178e-07 -0.09740493783372779 -1.4257 0.7025066798340289 0.7025047647415492 -1.306586088888756e-07 -0.09740571593920723 -1.4258000000000002 0.7025080629216782 0.702506149867903 -1.375418635495701e-07 -0.09740649381444422 -1.4259000000000002 0.7025094455238552 0.7025075346551531 -1.444015787083197e-07 -0.09740727145950506 -1.426 0.7025108276409499 0.7025089191031498 -1.5123619853153747e-07 -0.09740804887445596 -1.4261000000000001 0.7025122092733687 0.7025103032117274 -1.5804417334390475e-07 -0.09740882605936323 -1.4262000000000001 0.7025135904215345 0.7025116869807033 -1.6482395995970345e-07 -0.09740960301429305 -1.4263000000000001 0.7025149710858872 0.702513070409879 -1.7157402204190375e-07 -0.09741037973931174 -1.4264000000000001 0.7025163512668822 0.7025144534990387 -1.7829283046472133e-07 -0.09741115623448543 -1.4265 0.7025177309649913 0.7025158362479516 -1.8497886363627591e-07 -0.09741193249988032 -1.4266 0.7025191101807025 0.7025172186563697 -1.9163060785767905e-07 -0.09741270853556258 -1.4267 0.7025204889145198 0.7025186007240294 -1.982465576422232e-07 -0.09741348434159838 -1.4268000000000003 0.7025218671669632 0.7025199824506504 -2.0482521610395987e-07 -0.0974142599180538 -1.4269 0.7025232449385685 0.7025213638359376 -2.113650952456636e-07 -0.09741503526499497 -1.427 0.7025246222298872 0.7025227448795791 -2.1786471633700177e-07 -0.09741581038248799 -1.4271 0.7025259990414865 0.7025241255812481 -2.2432261019555977e-07 -0.09741658527059895 -1.4272 0.7025273753739489 0.7025255059406016 -2.3073731758235794e-07 -0.09741735992939385 -1.4273000000000002 0.7025287512278728 0.7025268859572815 -2.3710738947246845e-07 -0.09741813435893881 -1.4274 0.7025301266038712 0.7025282656309142 -2.4343138745747117e-07 -0.0974189085592998 -1.4275 0.7025315015025728 0.7025296449611107 -2.49707883981376e-07 -0.09741968253054284 -1.4276000000000002 0.7025328759246217 0.7025310239474668 -2.5593546271879264e-07 -0.0974204562727339 -1.4277 0.7025342498706759 0.7025324025895636 -2.6211271888371135e-07 -0.09742122978593895 -1.4278000000000002 0.7025356233414093 0.7025337808869672 -2.682382595417532e-07 -0.09742200307022396 -1.4279000000000002 0.7025369963375101 0.7025351588392289 -2.7431070391201184e-07 -0.09742277612565488 -1.428 0.7025383688596807 0.7025365364458853 -2.803286837244068e-07 -0.09742354895229756 -1.4281000000000001 0.702539740908638 0.7025379137064587 -2.8629084347295275e-07 -0.09742432155021792 -1.4282000000000001 0.7025411124851141 0.7025392906204568 -2.92195840734949e-07 -0.0974250939194819 -1.4283000000000001 0.7025424835898539 0.7025406671873735 -2.9804234651098493e-07 -0.0974258660601553 -1.4284000000000001 0.7025438542236173 0.702542043406688 -3.038290454712711e-07 -0.09742663797230396 -1.4285 0.7025452243871775 0.7025434192778663 -3.095546362921753e-07 -0.09742740965599374 -1.4286 0.7025465940813216 0.7025447948003603 -3.152178319060228e-07 -0.09742818111129042 -1.4287 0.7025479633068499 0.7025461699736079 -3.208173598653885e-07 -0.09742895233825977 -1.4288000000000003 0.7025493320645769 0.7025475447970345 -3.2635196251656895e-07 -0.0974297233369676 -1.4289 0.7025507003553292 0.7025489192700515 -3.318203973881606e-07 -0.09743049410747963 -1.429 0.7025520681799475 0.7025502933920573 -3.372214374131044e-07 -0.09743126464986164 -1.4291 0.7025534355392847 0.7025516671624379 -3.4255387125481374e-07 -0.09743203496417938 -1.4292 0.7025548024342065 0.7025530405805654 -3.4781650346676907e-07 -0.09743280505049844 -1.4293000000000002 0.7025561688655914 0.7025544136458004 -3.530081548949737e-07 -0.09743357490888455 -1.4294 0.7025575348343299 0.7025557863574903 -3.5812766287224296e-07 -0.09743434453940339 -1.4295 0.702558900341325 0.7025571587149708 -3.631738814818819e-07 -0.09743511394212057 -1.4296000000000002 0.7025602653874917 0.7025585307175652 -3.681456818352413e-07 -0.09743588311710176 -1.4297 0.7025616299737565 0.7025599023645853 -3.7304195229376225e-07 -0.09743665206441253 -1.4298000000000002 0.7025629941010576 0.7025612736553306 -3.778615987187761e-07 -0.09743742078411848 -1.4299000000000002 0.7025643577703454 0.7025626445890898 -3.826035447976328e-07 -0.09743818927628527 -1.43 0.7025657209825802 0.7025640151651399 -3.8726673214778407e-07 -0.09743895754097835 -1.4301000000000001 0.7025670837387342 0.7025653853827465 -3.9185012065678926e-07 -0.0974397255782633 -1.4302000000000001 0.7025684460397905 0.702566755241165 -3.9635268866966555e-07 -0.09744049338820565 -1.4303000000000001 0.7025698078867426 0.7025681247396396 -4.007734332386881e-07 -0.09744126097087095 -1.4304000000000001 0.7025711692805943 0.7025694938774038 -4.0511137033155675e-07 -0.09744202832632455 -1.4305 0.70257253022236 0.7025708626536813 -4.093655350395631e-07 -0.09744279545463205 -1.4306 0.7025738907130641 0.7025722310676855 -4.1353498181351256e-07 -0.09744356235585887 -1.4307 0.7025752507537405 0.7025735991186196 -4.17618784706586e-07 -0.09744432903007039 -1.4308 0.7025766103454327 0.7025749668056775 -4.216160374992395e-07 -0.09744509547733202 -1.4309 0.7025779694891943 0.7025763341280438 -4.255258539420659e-07 -0.09744586169770922 -1.431 0.7025793281860873 0.702577701084893 -4.2934736796396145e-07 -0.09744662769126734 -1.4311 0.7025806864371831 0.7025790676753915 -4.330797338525372e-07 -0.09744739345807171 -1.4312 0.7025820442435616 0.7025804338986965 -4.367221264553467e-07 -0.09744815899818775 -1.4313000000000002 0.7025834016063117 0.7025817997539563 -4.4027374130478636e-07 -0.0974489243116807 -1.4314 0.7025847585265301 0.7025831652403116 -4.4373379486095654e-07 -0.09744968939861598 -1.4315 0.7025861150053219 0.702584530356894 -4.471015246781951e-07 -0.0974504542590588 -1.4316000000000002 0.7025874710437996 0.7025858951028281 -4.5037618955079406e-07 -0.0974512188930744 -1.4317 0.7025888266430836 0.70258725947723 -4.5355706967953324e-07 -0.09745198330072809 -1.4318000000000002 0.7025901818043021 0.7025886234792087 -4.5664346681739687e-07 -0.0974527474820851 -1.4319000000000002 0.7025915365285902 0.7025899871078662 -4.5963470449161825e-07 -0.09745351143721065 -1.432 0.7025928908170894 0.7025913503622974 -4.6253012800367976e-07 -0.09745427516617 -1.4321000000000002 0.7025942446709488 0.7025927132415899 -4.653291047068686e-07 -0.09745503866902827 -1.4322000000000001 0.7025955980913228 0.7025940757448255 -4.680310241519936e-07 -0.09745580194585057 -1.4323000000000001 0.7025969510793731 0.702595437871079 -4.7063529815677407e-07 -0.09745656499670209 -1.4324000000000001 0.7025983036362671 0.70259679961942 -4.731413608960455e-07 -0.09745732782164804 -1.4325 0.702599655763178 0.7025981609889116 -4.7554866910992644e-07 -0.09745809042075346 -1.4326 0.7026010074612837 0.7025995219786116 -4.778567022079017e-07 -0.09745885279408345 -1.4327 0.7026023587317687 0.7026008825875727 -4.800649623590281e-07 -0.09745961494170313 -1.4328 0.7026037095758211 0.702602242814842 -4.821729745752013e-07 -0.09746037686367749 -1.4329 0.7026050599946346 0.702603602659462 -4.841802868568723e-07 -0.09746113856007159 -1.433 0.7026064099894076 0.7026049621204706 -4.860864702693757e-07 -0.09746190003095044 -1.4331 0.7026077595613425 0.7026063211969018 -4.878911190678292e-07 -0.09746266127637912 -1.4332 0.7026091087116453 0.7026076798877848 -4.895938507318287e-07 -0.09746342229642253 -1.4333000000000002 0.7026104574415266 0.7026090381921457 -4.911943060556534e-07 -0.09746418309114578 -1.4334 0.7026118057521997 0.7026103961090064 -4.926921492454106e-07 -0.09746494366061373 -1.4335 0.7026131536448819 0.7026117536373857 -4.940870679814857e-07 -0.09746570400489132 -1.4336000000000002 0.7026145011207927 0.702613110776299 -4.9537877349487e-07 -0.09746646412404347 -1.4337 0.7026158481811552 0.7026144675247592 -4.965670005879774e-07 -0.09746722401813504 -1.4338000000000002 0.7026171948271944 0.7026158238817766 -4.976515077526056e-07 -0.09746798368723093 -1.4339000000000002 0.7026185410601381 0.7026171798463592 -4.986320771352415e-07 -0.09746874313139607 -1.434 0.7026198868812156 0.7026185354175131 -4.995085146758393e-07 -0.09746950235069526 -1.4341000000000002 0.7026212322916583 0.7026198905942419 -5.002806500592483e-07 -0.09747026134519332 -1.4342000000000001 0.7026225772926988 0.7026212453755482 -5.009483367776624e-07 -0.09747102011495508 -1.4343000000000001 0.7026239218855717 0.7026225997604331 -5.015114522000097e-07 -0.09747177866004535 -1.4344000000000001 0.7026252660715117 0.7026239537478967 -5.019698974886855e-07 -0.09747253698052888 -1.4345 0.7026266098517545 0.7026253073369382 -5.023235977869023e-07 -0.09747329507647044 -1.4346 0.7026279532275366 0.7026266605265565 -5.02572502024401e-07 -0.0974740529479348 -1.4347 0.7026292962000942 0.7026280133157496 -5.027165830770453e-07 -0.09747481059498662 -1.4348 0.702630638770664 0.7026293657035164 -5.027558377182495e-07 -0.09747556801769065 -1.4349 0.7026319809404822 0.7026307176888553 -5.026902865634675e-07 -0.0974763252161116 -1.435 0.7026333227107844 0.7026320692707653 -5.025199741465203e-07 -0.09747708219031413 -1.4351 0.7026346640828056 0.7026334204482464 -5.022449688640851e-07 -0.09747783894036292 -1.4352 0.7026360050577795 0.702634771220299 -5.018653628993675e-07 -0.09747859546632254 -1.4353000000000002 0.7026373456369384 0.7026361215859254 -5.013812722914901e-07 -0.09747935176825759 -1.4354 0.7026386858215136 0.7026374715441288 -5.007928368314096e-07 -0.09748010784623275 -1.4355 0.7026400256127342 0.702638821093915 -5.001002200688554e-07 -0.0974808637003126 -1.4356000000000002 0.7026413650118273 0.7026401702342906 -4.993036092221237e-07 -0.09748161933056165 -1.4357 0.7026427040200175 0.7026415189642654 -4.984032151642004e-07 -0.09748237473704452 -1.4358000000000002 0.7026440426385271 0.7026428672828509 -4.973992723741882e-07 -0.0974831299198256 -1.4359000000000002 0.7026453808685756 0.7026442151890622 -4.962920388471015e-07 -0.09748388487896953 -1.436 0.7026467187113794 0.702645562681917 -4.950817960314158e-07 -0.09748463961454075 -1.4361000000000002 0.7026480561681516 0.7026469097604362 -4.937688487804959e-07 -0.09748539412660379 -1.4362000000000001 0.7026493932401019 0.7026482564236444 -4.923535252901456e-07 -0.09748614841522313 -1.4363000000000001 0.7026507299284357 0.7026496026705695 -4.908361769667691e-07 -0.09748690248046316 -1.4364000000000001 0.7026520662343544 0.7026509485002441 -4.892171783510424e-07 -0.09748765632238832 -1.4365 0.7026534021590555 0.7026522939117044 -4.874969270693419e-07 -0.09748840994106302 -1.4366 0.7026547377037318 0.7026536389039912 -4.856758437227215e-07 -0.09748916333655162 -1.4367 0.702656072869571 0.7026549834761502 -4.837543717273185e-07 -0.0974899165089185 -1.4368 0.7026574076577564 0.702656327627232 -4.817329772935364e-07 -0.09749066945822803 -1.4369 0.7026587420694654 0.7026576713562924 -4.796121492664507e-07 -0.09749142218454455 -1.437 0.7026600761058706 0.702659014662393 -4.773923989939699e-07 -0.09749217468793242 -1.4371 0.7026614097681378 0.7026603575446004 -4.750742602158131e-07 -0.0974929269684559 -1.4372 0.7026627430574277 0.7026617000019877 -4.726582889941211e-07 -0.0974936790261793 -1.4373000000000002 0.7026640759748942 0.7026630420336337 -4.701450634914117e-07 -0.09749443086116683 -1.4374 0.7026654085216852 0.702664383638624 -4.675351838526187e-07 -0.09749518247348275 -1.4375 0.7026667406989415 0.7026657248160507 -4.648292721357028e-07 -0.09749593386319132 -1.4376000000000002 0.7026680725077976 0.7026670655650129 -4.620279721104237e-07 -0.09749668503035679 -1.4377 0.7026694039493798 0.7026684058846163 -4.591319490154788e-07 -0.09749743597504326 -1.4378000000000002 0.702670735024808 0.7026697457739745 -4.5614188956544233e-07 -0.097498186697315 -1.4379000000000002 0.7026720657351941 0.7026710852322084 -4.5305850169402584e-07 -0.09749893719723617 -1.438 0.702673396081642 0.702672424258447 -4.4988251444999516e-07 -0.09749968747487088 -1.4381000000000002 0.7026747260652481 0.7026737628518266 -4.466146777126756e-07 -0.09750043753028333 -1.4382000000000001 0.7026760556870995 0.702675101011492 -4.4325576209480744e-07 -0.09750118736353751 -1.4383000000000001 0.7026773849482757 0.7026764387365969 -4.398065587898903e-07 -0.09750193697469757 -1.4384000000000001 0.7026787138498474 0.7026777760263032 -4.3626787932932176e-07 -0.0975026863638276 -1.4385 0.7026800423928756 0.7026791128797818 -4.3264055538810853e-07 -0.09750343553099164 -1.4386 0.7026813705784131 0.7026804492962124 -4.2892543863914945e-07 -0.09750418447625375 -1.4387 0.7026826984075031 0.7026817852747846 -4.2512340050343544e-07 -0.09750493319967796 -1.4388 0.7026840258811791 0.7026831208146972 -4.2123533199045493e-07 -0.09750568170132828 -1.4389 0.702685353000464 0.702684455915158 -4.1726214344839363e-07 -0.09750642998126857 -1.439 0.7026866797663727 0.7026857905753859 -4.1320476439066223e-07 -0.09750717803956298 -1.4391 0.7026880061799079 0.7026871247946094 -4.090641432391573e-07 -0.09750792587627537 -1.4392 0.702689332242063 0.7026884585720672 -4.0484124713691116e-07 -0.09750867349146967 -1.4393000000000002 0.7026906579538207 0.7026897919070088 -4.0053706167053615e-07 -0.09750942088520986 -1.4394 0.7026919833161529 0.7026911247986938 -3.961525907245078e-07 -0.09751016805755981 -1.4395 0.7026933083300202 0.7026924572463935 -3.9168885618973137e-07 -0.0975109150085834 -1.4396000000000002 0.7026946329963726 0.7026937892493899 -3.8714689770680266e-07 -0.09751166173834451 -1.4397 0.7026959573161482 0.702695120806976 -3.82527772478658e-07 -0.09751240824690695 -1.4398000000000002 0.7026972812902739 0.7026964519184568 -3.778325549930184e-07 -0.09751315453433457 -1.4399000000000002 0.7026986049196651 0.7026977825831484 -3.7306233680034495e-07 -0.0975139006006912 -1.44 0.7026999282052248 0.7026991128003794 -3.682182262293443e-07 -0.09751464644604065 -1.4401000000000002 0.702701251147844 0.7027004425694896 -3.633013481163516e-07 -0.09751539207044663 -1.4402000000000001 0.7027025737484022 0.7027017718898315 -3.5831284363879723e-07 -0.09751613747397299 -1.4403000000000001 0.7027038960077654 0.7027031007607696 -3.532538698849952e-07 -0.09751688265668335 -1.4404000000000001 0.7027052179267881 0.7027044291816815 -3.481255997084265e-07 -0.09751762761864159 -1.4405 0.7027065395063112 0.702705757151957 -3.429292214779389e-07 -0.09751837235991136 -1.4406 0.7027078607471628 0.7027070846709986 -3.3766593870304673e-07 -0.09751911688055626 -1.4407 0.7027091816501589 0.7027084117382224 -3.3233696983964167e-07 -0.09751986118064013 -1.4408 0.7027105022161011 0.7027097383530568 -3.2694354792917046e-07 -0.0975206052602265 -1.4409 0.7027118224457782 0.7027110645149444 -3.21486920390468e-07 -0.09752134911937908 -1.441 0.7027131423399655 0.7027123902233403 -3.159683487213849e-07 -0.09752209275816145 -1.4411 0.7027144618994242 0.7027137154777142 -3.1038910815184284e-07 -0.09752283617663722 -1.4412 0.7027157811249023 0.7027150402775487 -3.047504874287288e-07 -0.09752357937487 -1.4413000000000002 0.7027171000171335 0.7027163646223409 -2.990537884065003e-07 -0.09752432235292335 -1.4414 0.7027184185768376 0.7027176885116015 -2.9330032583901877e-07 -0.09752506511086084 -1.4415 0.7027197368047198 0.7027190119448556 -2.8749142707076847e-07 -0.09752580764874595 -1.4416000000000002 0.7027210547014715 0.7027203349216424 -2.816284316864426e-07 -0.09752654996664228 -1.4417 0.7027223722677693 0.7027216574415157 -2.7571269125420406e-07 -0.09752729206461329 -1.4418000000000002 0.702723689504275 0.7027229795040438 -2.697455689613937e-07 -0.09752803394272247 -1.4419000000000002 0.7027250064116362 0.7027243011088093 -2.6372843934738266e-07 -0.09752877560103324 -1.442 0.7027263229904852 0.7027256222554104 -2.576626879531585e-07 -0.0975295170396091 -1.4421000000000002 0.7027276392414397 0.702726942943459 -2.5154971100907475e-07 -0.09753025825851351 -1.4422000000000001 0.7027289551651021 0.7027282631725833 -2.4539091513994804e-07 -0.09753099925780984 -1.4423000000000001 0.7027302707620596 0.7027295829424254 -2.3918771700076613e-07 -0.09753174003756149 -1.4424000000000001 0.7027315860328844 0.7027309022526436 -2.3294154297484604e-07 -0.09753248059783183 -1.4425 0.7027329009781331 0.7027322211029108 -2.2665382886505325e-07 -0.09753322093868427 -1.4426 0.702734215598347 0.7027335394929158 -2.2032601951910147e-07 -0.09753396106018218 -1.4427 0.7027355298940513 0.7027348574223624 -2.1395956852424125e-07 -0.09753470096238873 -1.4428 0.7027368438657562 0.7027361748909704 -2.0755593788807092e-07 -0.09753544064536733 -1.4429 0.7027381575139562 0.7027374918984753 -2.0111659766036682e-07 -0.09753618010918132 -1.443 0.7027394708391292 0.702738808444628 -1.9464302562430258e-07 -0.09753691935389391 -1.4431 0.7027407838417383 0.7027401245291955 -1.8813670696338214e-07 -0.09753765837956839 -1.4432 0.7027420965222295 0.7027414401519606 -1.8159913390755622e-07 -0.09753839718626797 -1.4433000000000002 0.7027434088810338 0.7027427553127221 -1.750318054001554e-07 -0.09753913577405592 -1.4434 0.7027447209185653 0.702744070011295 -1.6843622674053704e-07 -0.09753987414299542 -1.4435 0.7027460326352222 0.70274538424751 -1.618139092388754e-07 -0.09754061229314964 -1.4436000000000002 0.7027473440313865 0.7027466980212147 -1.5516636989350296e-07 -0.09754135022458182 -1.4437 0.7027486551074241 0.7027480113322722 -1.4849513102314915e-07 -0.0975420879373551 -1.4438000000000002 0.7027499658636841 0.7027493241805622 -1.4180171993387336e-07 -0.09754282543153257 -1.4439000000000002 0.7027512763004997 0.7027506365659808 -1.3508766853742582e-07 -0.09754356270717744 -1.444 0.7027525864181872 0.7027519484884399 -1.283545130424668e-07 -0.0975442997643527 -1.4441000000000002 0.7027538962170465 0.7027532599478689 -1.2160379357466222e-07 -0.09754503660312148 -1.4442000000000002 0.7027552056973614 0.7027545709442127 -1.1483705383841247e-07 -0.09754577322354689 -1.4443000000000001 0.7027565148593986 0.7027558814774328 -1.0805584075256058e-07 -0.09754650962569193 -1.4444000000000001 0.7027578237034087 0.7027571915475079 -1.0126170410865165e-07 -0.09754724580961965 -1.4445 0.7027591322296254 0.7027585011544326 -9.445619621357981e-08 -0.09754798177539309 -1.4446 0.7027604404382657 0.7027598102982181 -8.764087152529632e-08 -0.0975487175230752 -1.4447 0.7027617483295301 0.7027611189788923 -8.081728631367108e-08 -0.097549453052729 -1.4448 0.7027630559036027 0.7027624271965 -7.398699829793548e-08 -0.09755018836441744 -1.4449 0.7027643631606502 0.7027637349511023 -6.715156628022204e-08 -0.09755092345820353 -1.445 0.7027656701008234 0.7027650422427769 -6.031254980859435e-08 -0.09755165833415011 -1.4451 0.7027669767242559 0.7027663490716183 -5.3471508812104676e-08 -0.09755239299232017 -1.4452 0.7027682830310649 0.7027676554377373 -4.6630003246368214e-08 -0.09755312743277655 -1.4453000000000003 0.7027695890213504 0.7027689613412618 -3.978959273550535e-08 -0.09755386165558215 -1.4454 0.7027708946951967 0.702770266782336 -3.2951836219938593e-08 -0.0975545956607999 -1.4455 0.7027722000526706 0.7027715717611207 -2.611829160044897e-08 -0.09755532944849254 -1.4456000000000002 0.7027735050938224 0.7027728762777932 -1.9290515381690382e-08 -0.09755606301872298 -1.4457 0.7027748098186858 0.7027741803325479 -1.2470062320420194e-08 -0.09755679637155397 -1.4458000000000002 0.7027761142272781 0.7027754839255949 -5.658485069393038e-09 -0.09755752950704831 -1.4459000000000002 0.7027774183196001 0.7027767870571616 1.1426661743543787e-09 -0.09755826242526884 -1.446 0.7027787220956356 0.7027780897274913 7.931844026205781e-09 -0.0975589951262783 -1.4461000000000002 0.702780025555352 0.7027793919368446 1.4707504257006898e-08 -0.0975597276101394 -1.4462000000000002 0.7027813286987005 0.7027806936854971 2.1468106153020583e-08 -0.09756045987691485 -1.4463000000000001 0.7027826315256154 0.702781994973742 2.8212112871545125e-08 -0.09756119192666737 -1.4464000000000001 0.7027839340360151 0.7027832958018884 3.493799176530754e-08 -0.09756192375945966 -1.4465 0.7027852362298018 0.7027845961702617 4.1644214757163844e-08 -0.09756265537535445 -1.4466 0.7027865381068606 0.7027858960792037 4.8329258678370124e-08 -0.09756338677441433 -1.4467 0.702787839667061 0.7027871955290719 5.4991605604251537e-08 -0.09756411795670195 -1.4468 0.702789140910256 0.7027884945202405 6.16297432306373e-08 -0.09756484892227994 -1.4469 0.7027904418362829 0.7027897930530993 6.82421651618248e-08 -0.09756557967121093 -1.447 0.7027917424449628 0.7027910911280543 7.482737130089234e-08 -0.0975663102035575 -1.4471 0.7027930427361007 0.7027923887455274 8.13838681827661e-08 -0.09756704051938221 -1.4472 0.7027943427094853 0.7027936859059558 8.791016929514395e-08 -0.09756777061874758 -1.4473000000000003 0.7027956423648902 0.7027949826097937 9.440479542197067e-08 -0.09756850050171618 -1.4474 0.702796941702073 0.7027962788575096 1.0086627497823963e-07 -0.09756923016835056 -1.4475 0.7027982407207758 0.7027975746495886 1.0729314436908055e-07 -0.0975699596187132 -1.4476000000000002 0.7027995394207246 0.7027988699865306 1.1368394826211103e-07 -0.09757068885286657 -1.4477 0.7028008378016306 0.7028001648688513 1.200372399846883e-07 -0.09757141787087314 -1.4478000000000002 0.7028021358631892 0.7028014592970817 1.263515817875871e-07 -0.09757214667279537 -1.4479000000000002 0.7028034336050808 0.7028027532717678 1.3262554523357784e-07 -0.09757287525869573 -1.448 0.7028047310269704 0.7028040467934709 1.388577114853906e-07 -0.09757360362863662 -1.4481000000000002 0.702806028128508 0.7028053398627672 1.4504667162837381e-07 -0.09757433178268039 -1.4482000000000002 0.7028073249093285 0.7028066324802478 1.511910269584582e-07 -0.09757505972088946 -1.4483000000000001 0.7028086213690523 0.7028079246465185 1.572893893846128e-07 -0.09757578744332622 -1.4484000000000001 0.7028099175072849 0.7028092163622001 1.6334038164741993e-07 -0.09757651495005298 -1.4485 0.7028112133236171 0.7028105076279272 1.6934263768683677e-07 -0.09757724224113203 -1.4486 0.7028125088176255 0.7028117984443498 1.752948029440371e-07 -0.09757796931662578 -1.4487 0.7028138039888719 0.7028130888121317 1.8119553462855875e-07 -0.09757869617659651 -1.4488 0.7028150988369044 0.7028143787319506 1.8704350208606502e-07 -0.09757942282110647 -1.4489 0.7028163933612566 0.7028156682044986 1.928373870412059e-07 -0.09758014925021792 -1.449 0.7028176875614485 0.7028169572304819 1.9857588393762393e-07 -0.09758087546399319 -1.4491 0.7028189814369857 0.7028182458106199 2.0425770017734601e-07 -0.09758160146249446 -1.4492 0.7028202749873607 0.7028195339456458 2.09881556474667e-07 -0.09758232724578392 -1.4493000000000003 0.7028215682120522 0.7028208216363063 2.1544618709901098e-07 -0.09758305281392377 -1.4494 0.7028228611105253 0.7028221088833617 2.2095034019065096e-07 -0.09758377816697617 -1.4495 0.7028241536822324 0.7028233956875851 2.2639277799663127e-07 -0.09758450330500332 -1.4496000000000002 0.7028254459266126 0.702824682049763 2.317722772177122e-07 -0.09758522822806737 -1.4497 0.7028267378430917 0.7028259679706937 2.370876292373536e-07 -0.09758595293623039 -1.4498000000000002 0.7028280294310834 0.7028272534511897 2.4233764038539274e-07 -0.09758667742955454 -1.4499000000000002 0.7028293206899885 0.7028285384920752 2.475211322156001e-07 -0.09758740170810193 -1.45 0.7028306116191952 0.702829823094187 2.5263694179017415e-07 -0.09758812577193464 -1.4501000000000002 0.7028319022180796 0.7028311072583736 2.5768392195035794e-07 -0.09758884962111464 -1.4502000000000002 0.7028331924860056 0.7028323909854963 2.626609415176673e-07 -0.0975895732557041 -1.4503000000000001 0.7028344824223254 0.7028336742764277 2.6756688559226305e-07 -0.09759029667576492 -1.4504000000000001 0.7028357720263795 0.7028349571320527 2.7240065578193473e-07 -0.09759101988135928 -1.4505 0.7028370612974963 0.7028362395532665 2.7716117047965616e-07 -0.097591742872549 -1.4506000000000001 0.7028383502349935 0.7028375215409768 2.8184736503705787e-07 -0.09759246564939615 -1.4507 0.7028396388381771 0.7028388030961019 2.864581921044329e-07 -0.09759318821196268 -1.4508 0.7028409271063423 0.7028400842195712 2.909926217556369e-07 -0.09759391056031046 -1.4509 0.7028422150387733 0.702841364912325 2.9544964182809386e-07 -0.09759463269450147 -1.451 0.7028435026347444 0.7028426451753136 2.998282580268796e-07 -0.0975953546145977 -1.4511 0.7028447898935184 0.7028439250094984 3.0412749423697205e-07 -0.0975960763206609 -1.4512 0.7028460768143482 0.7028452044158504 3.083463927591734e-07 -0.09759679781275299 -1.4513000000000003 0.7028473633964771 0.7028464833953509 3.124840144141938e-07 -0.09759751909093586 -1.4514 0.7028486496391385 0.702847761948991 3.1653943882020696e-07 -0.09759824015527134 -1.4515 0.7028499355415556 0.7028490400777709 3.205117646426503e-07 -0.09759896100582123 -1.4516000000000002 0.7028512211029426 0.7028503177827008 3.2440010973300293e-07 -0.09759968164264733 -1.4517 0.7028525063225044 0.7028515950647997 3.2820361129531905e-07 -0.09760040206581148 -1.4518000000000002 0.702853791199437 0.7028528719250955 3.3192142614296705e-07 -0.09760112227537537 -1.4519000000000002 0.7028550757329273 0.7028541483646249 3.355527308998574e-07 -0.09760184227140084 -1.452 0.702856359922154 0.7028554243844334 3.3909672206983155e-07 -0.09760256205394957 -1.4521000000000002 0.7028576437662871 0.7028566999855748 3.4255261632115674e-07 -0.09760328162308335 -1.4522 0.7028589272644887 0.7028579751691104 3.45919650673876e-07 -0.09760400097886385 -1.4523000000000001 0.7028602104159125 0.7028592499361097 3.491970825761359e-07 -0.0976047201213527 -1.4524000000000001 0.702861493219705 0.7028605242876501 3.52384190091537e-07 -0.09760543905061164 -1.4525 0.7028627756750052 0.7028617982248164 3.5548027212117805e-07 -0.0976061577667023 -1.4526000000000001 0.7028640577809444 0.7028630717487002 3.584846485632509e-07 -0.09760687626968632 -1.4527 0.7028653395366473 0.7028643448604003 3.613966602852847e-07 -0.09760759455962531 -1.4528 0.7028666209412315 0.7028656175610224 3.642156695127241e-07 -0.0976083126365809 -1.4529 0.702867901993808 0.7028668898516786 3.669410598081124e-07 -0.09760903050061465 -1.453 0.7028691826934818 0.7028681617334871 3.6957223625844193e-07 -0.09760974815178812 -1.4531 0.7028704630393512 0.7028694332075729 3.721086255792372e-07 -0.09761046559016291 -1.4532 0.7028717430305089 0.7028707042750657 3.7454967630190517e-07 -0.09761118281580049 -1.4533000000000003 0.7028730226660422 0.7028719749371021 3.7689485880842977e-07 -0.09761189982876245 -1.4534 0.7028743019450326 0.7028732451948227 3.791436655464775e-07 -0.09761261662911025 -1.4535 0.7028755808665565 0.7028745150493744 3.8129561103633636e-07 -0.09761333321690539 -1.4536000000000002 0.7028768594296854 0.7028757845019081 3.8335023200969376e-07 -0.0976140495922093 -1.4537 0.702878137633486 0.7028770535535801 3.85307087506781e-07 -0.09761476575508352 -1.4538000000000002 0.7028794154770208 0.7028783222055505 3.8716575903596784e-07 -0.09761548170558937 -1.4539000000000002 0.7028806929593476 0.7028795904589837 3.8892585060845697e-07 -0.09761619744378833 -1.454 0.7028819700795208 0.7028808583150485 3.9058698882155074e-07 -0.09761691296974184 -1.4541000000000002 0.7028832468365905 0.7028821257749169 3.9214882287946784e-07 -0.09761762828351123 -1.4542 0.7028845232296035 0.7028833928397644 3.936110247945712e-07 -0.09761834338515785 -1.4543000000000001 0.7028857992576032 0.7028846595107701 3.949732893734903e-07 -0.09761905827474311 -1.4544000000000001 0.7028870749196305 0.7028859257891152 3.9623533426569324e-07 -0.09761977295232832 -1.4545 0.7028883502147228 0.7028871916759845 3.973969000953259e-07 -0.09762048741797473 -1.4546000000000001 0.7028896251419157 0.7028884571725651 3.984577504473341e-07 -0.09762120167174378 -1.4547 0.7028908997002418 0.7028897222800458 3.994176719229747e-07 -0.09762191571369663 -1.4548 0.702892173888732 0.7028909869996178 4.002764742716547e-07 -0.09762262954389461 -1.4549 0.7028934477064157 0.702892251332474 4.0103399024521424e-07 -0.09762334316239893 -1.455 0.7028947211523204 0.7028935152798086 4.01690075854666e-07 -0.09762405656927087 -1.4551 0.702895994225472 0.7028947788428175 4.0224461016202806e-07 -0.09762476976457161 -1.4552 0.7028972669248961 0.702896042022697 4.02697495488491e-07 -0.09762548274836237 -1.4553000000000003 0.7028985392496171 0.7028973048206444 4.0304865740747875e-07 -0.09762619552070434 -1.4554 0.7028998111986586 0.7028985672378572 4.0329804457811536e-07 -0.09762690808165861 -1.4555 0.7029010827710446 0.702899829275534 4.034456290019639e-07 -0.09762762043128644 -1.4556000000000002 0.7029023539657981 0.7029010909348723 4.0349140582873755e-07 -0.09762833256964887 -1.4557 0.7029036247819433 0.7029023522170701 4.0343539344650514e-07 -0.0976290444968071 -1.4558000000000002 0.7029048952185042 0.7029036131233245 4.032776334886301e-07 -0.09762975621282216 -1.4559000000000002 0.7029061652745052 0.702904873654832 4.030181907505037e-07 -0.09763046771775513 -1.456 0.7029074349489728 0.7029061338127883 4.026571531895451e-07 -0.09763117901166712 -1.4561000000000002 0.7029087042409335 0.7029073935983874 4.0219463186969007e-07 -0.09763189009461917 -1.4562 0.7029099731494157 0.702908653012822 4.0163076109323015e-07 -0.09763260096667226 -1.4563000000000001 0.7029112416734495 0.7029099120572835 4.0096569806080673e-07 -0.09763331162788745 -1.4564000000000001 0.7029125098120672 0.7029111707329607 4.0019962316284463e-07 -0.0976340220783258 -1.4565 0.7029137775643026 0.7029124290410406 3.9933273966730187e-07 -0.0976347323180482 -1.4566000000000001 0.7029150449291923 0.7029136869827073 3.98365273830692e-07 -0.09763544234711563 -1.4567 0.7029163119057754 0.7029149445591425 3.97297474766245e-07 -0.09763615216558907 -1.4568 0.7029175784930943 0.7029162017715248 3.9612961437451855e-07 -0.09763686177352943 -1.4569 0.7029188446901942 0.70291745862103 3.9486198731564226e-07 -0.09763757117099765 -1.457 0.7029201104961234 0.7029187151088294 3.934949109815622e-07 -0.09763828035805454 -1.4571 0.7029213759099346 0.702919971236092 3.9202872524624066e-07 -0.0976389893347611 -1.4572 0.7029226409306839 0.702921227003982 3.904637925766785e-07 -0.09763969810117816 -1.4573000000000003 0.7029239055574312 0.7029224824136593 3.88800497783115e-07 -0.09764040665736651 -1.4574 0.7029251697892416 0.70292373746628 3.8703924805372214e-07 -0.09764111500338707 -1.4575 0.7029264336251837 0.7029249921629953 3.8518047279501033e-07 -0.09764182313930056 -1.4576000000000002 0.7029276970643319 0.7029262465049514 3.83224623513867e-07 -0.09764253106516785 -1.4577 0.702928960105765 0.7029275004932897 3.811721737412288e-07 -0.09764323878104973 -1.4578000000000002 0.7029302227485674 0.7029287541291456 3.790236189349372e-07 -0.0976439462870069 -1.4579000000000002 0.702931484991829 0.7029300074136497 3.767794762576937e-07 -0.09764465358310015 -1.458 0.7029327468346454 0.7029312603479262 3.744402845909378e-07 -0.09764536066939018 -1.4581000000000002 0.7029340082761177 0.7029325129330936 3.720066043128023e-07 -0.09764606754593771 -1.4582 0.7029352693153543 0.7029337651702641 3.694790171732132e-07 -0.09764677421280349 -1.4583000000000002 0.7029365299514694 0.7029350170605433 3.6685812625225633e-07 -0.09764748067004818 -1.4584000000000001 0.7029377901835834 0.70293626860503 3.6414455566180504e-07 -0.09764818691773239 -1.4585 0.7029390500108241 0.7029375198048162 3.6133895051776443e-07 -0.09764889295591679 -1.4586000000000001 0.7029403094323268 0.7029387706609871 3.584419767180269e-07 -0.09764959878466209 -1.4587 0.7029415684472333 0.7029400211746194 3.554543207967553e-07 -0.09765030440402882 -1.4588 0.7029428270546936 0.7029412713467833 3.5237668986193293e-07 -0.09765100981407757 -1.4589 0.7029440852538649 0.702942521178541 3.4920981124147987e-07 -0.09765171501486898 -1.459 0.7029453430439128 0.7029437706709458 3.459544324693753e-07 -0.09765242000646358 -1.4591 0.702946600424011 0.702945019825044 3.426113210705517e-07 -0.09765312478892196 -1.4592 0.7029478573933416 0.7029462686418726 3.391812642625225e-07 -0.09765382936230459 -1.4593000000000003 0.7029491139510949 0.7029475171224602 3.356650690247709e-07 -0.097654533726672 -1.4594 0.702950370096471 0.7029487652678263 3.320635616338441e-07 -0.09765523788208474 -1.4595 0.7029516258286778 0.7029500130789818 3.2837758764253655e-07 -0.09765594182860321 -1.4596000000000002 0.7029528811469332 0.7029512605569277 3.24608011616212e-07 -0.09765664556628795 -1.4597 0.7029541360504645 0.7029525077026559 3.2075571695239224e-07 -0.09765734909519933 -1.4598000000000002 0.7029553905385085 0.7029537545171489 3.1682160566565143e-07 -0.09765805241539789 -1.4599000000000002 0.7029566446103117 0.7029550010013785 3.1280659815863254e-07 -0.09765875552694397 -1.46 0.7029578982651307 0.7029562471563069 3.0871163309020844e-07 -0.09765945842989796 -1.4601000000000002 0.7029591515022323 0.7029574929828861 3.0453766699384266e-07 -0.09766016112432029 -1.4602 0.7029604043208937 0.7029587384820577 3.002856742290172e-07 -0.09766086361027126 -1.4603000000000002 0.7029616567204029 0.7029599836547523 2.9595664666204335e-07 -0.0976615658878113 -1.4604000000000001 0.7029629087000584 0.70296122850189 2.9155159342320047e-07 -0.09766226795700073 -1.4605 0.7029641602591694 0.7029624730243795 2.870715407124469e-07 -0.09766296981789976 -1.4606000000000001 0.7029654113970569 0.702963717223119 2.8251753157737536e-07 -0.09766367147056881 -1.4607 0.7029666621130528 0.7029649610989945 2.7789062563565725e-07 -0.0976643729150681 -1.4608 0.7029679124065006 0.7029662046528812 2.7319189878360906e-07 -0.09766507415145796 -1.4609 0.702969162276755 0.7029674478856418 2.684224430296589e-07 -0.09766577517979855 -1.461 0.7029704117231833 0.702968690798128 2.635833662237297e-07 -0.09766647600015016 -1.4611 0.7029716607451643 0.702969933391179 2.5867579177274447e-07 -0.09766717661257303 -1.4612 0.7029729093420891 0.7029711756656214 2.5370085838388734e-07 -0.09766787701712729 -1.4613000000000003 0.7029741575133608 0.7029724176222703 2.486597198009255e-07 -0.09766857721387319 -1.4614 0.7029754052583953 0.7029736592619276 2.4355354454747014e-07 -0.09766927720287086 -1.4615 0.7029766525766212 0.7029749005853827 2.383835156771763e-07 -0.09766997698418045 -1.4616000000000002 0.7029778994674798 0.7029761415934122 2.3315083048924823e-07 -0.0976706765578621 -1.4617 0.7029791459304248 0.7029773822867798 2.2785670017455573e-07 -0.09767137592397596 -1.4618000000000002 0.7029803919649236 0.7029786226662357 2.2250234964910076e-07 -0.09767207508258202 -1.4619000000000002 0.702981637570457 0.7029798627325174 2.1708901721401164e-07 -0.09767277403374053 -1.462 0.7029828827465181 0.7029811024863486 2.1161795424329277e-07 -0.09767347277751141 -1.4621000000000002 0.7029841274926146 0.7029823419284397 2.0609042497912733e-07 -0.0976741713139548 -1.4622 0.7029853718082675 0.7029835810594871 2.005077061606464e-07 -0.09767486964313074 -1.4623000000000002 0.7029866156930109 0.7029848198801736 1.9487108674984266e-07 -0.09767556776509921 -1.4624000000000001 0.7029878591463936 0.7029860583911678 1.8918186766095357e-07 -0.09767626567992017 -1.4625 0.7029891021679782 0.7029872965931248 1.8344136141351663e-07 -0.09767696338765373 -1.4626000000000001 0.7029903447573411 0.7029885344866851 1.7765089187909977e-07 -0.09767766088835977 -1.4627000000000001 0.7029915869140733 0.7029897720724745 1.7181179396558166e-07 -0.0976783581820982 -1.4628 0.7029928286377799 0.7029910093511054 1.6592541329102373e-07 -0.09767905526892906 -1.4629 0.7029940699280808 0.7029922463231747 1.59993105864481e-07 -0.09767975214891217 -1.463 0.7029953107846101 0.7029934829892653 1.5401623778762974e-07 -0.09768044882210752 -1.4631 0.7029965512070167 0.7029947193499453 1.4799618497721156e-07 -0.09768114528857497 -1.4632 0.7029977911949646 0.7029959554057676 1.419343327764555e-07 -0.0976818415483744 -1.4633000000000003 0.702999030748132 0.7029971911572703 1.3583207570180833e-07 -0.09768253760156563 -1.4634 0.7030002698662129 0.7029984266049769 1.2969081706129537e-07 -0.09768323344820853 -1.4635 0.7030015085489154 0.702999661749395 1.2351196871165926e-07 -0.09768392908836289 -1.4636000000000002 0.7030027467959636 0.7030008965910175 1.1729695065243462e-07 -0.09768462452208855 -1.4637 0.7030039846070965 0.7030021311303221 1.1104719076920899e-07 -0.09768531974944523 -1.4638000000000002 0.7030052219820682 0.7030033653677707 1.04764124431167e-07 -0.09768601477049278 -1.4639000000000002 0.7030064589206484 0.7030045993038104 9.844919422741238e-08 -0.09768670958529092 -1.464 0.7030076954226223 0.7030058329388722 9.210384959573714e-08 -0.0976874041938994 -1.4641000000000002 0.7030089314877908 0.7030070662733714 8.572954653118803e-08 -0.09768809859637792 -1.4642 0.7030101671159695 0.7030082993077085 7.932774720616209e-08 -0.0976887927927862 -1.4643000000000002 0.703011402306991 0.7030095320422673 7.2899919654687e-08 -0.09768948678318391 -1.4644000000000001 0.7030126370607027 0.7030107644774165 6.644753743068055e-08 -0.09769018056763079 -1.4645 0.7030138713769681 0.7030119966135087 5.997207929743509e-08 -0.09769087414618643 -1.4646000000000001 0.7030151052556664 0.7030132284508802 5.3475028851182604e-08 -0.0976915675189105 -1.4647000000000001 0.7030163386966926 0.7030144599898522 4.6957874205375005e-08 -0.0976922606858626 -1.4648 0.7030175716999578 0.7030156912307295 4.042210763159637e-08 -0.09769295364710234 -1.4649 0.703018804265389 0.7030169221738007 3.386922524384328e-08 -0.09769364640268935 -1.465 0.7030200363929291 0.7030181528193389 2.7300726623824545e-08 -0.09769433895268316 -1.4651 0.703021268082537 0.7030193831676004 2.0718114508710972e-08 -0.09769503129714333 -1.4652 0.7030224993341879 0.7030206132188261 1.4122894425108723e-08 -0.09769572343612945 -1.4653000000000003 0.7030237301478728 0.7030218429732402 7.516574357727124e-09 -0.09769641536970099 -1.4654 0.703024960523599 0.7030230724310511 9.006643954950766e-10 -0.0976971070979175 -1.4655 0.7030261904613898 0.7030243015924508 -5.723323603240571e-09 -0.09769779862083841 -1.4656000000000002 0.7030274199612848 0.7030255304576152 -1.2353876361129168e-08 -0.0976984899385233 -1.4657 0.7030286490233395 0.7030267590267039 -1.898947953136304e-08 -0.09769918105103156 -1.4658000000000002 0.7030298776476256 0.7030279872998605 -2.5628618040285378e-08 -0.09769987195842264 -1.4659 0.7030311058342311 0.7030292152772121 -3.226977642913076e-08 -0.09770056266075597 -1.466 0.7030323335832602 0.7030304429588697 -3.8911439206716116e-08 -0.09770125315809099 -1.4661000000000002 0.7030335608948333 0.7030316703449282 -4.555209118939233e-08 -0.09770194345048704 -1.4662 0.7030347877690863 0.7030328974354662 -5.219021785162099e-08 -0.09770263353800354 -1.4663000000000002 0.703036014206172 0.7030341242305461 -5.882430566695601e-08 -0.09770332342069984 -1.4664000000000001 0.7030372402062591 0.7030353507302141 -6.545284245412092e-08 -0.0977040130986353 -1.4665 0.7030384657695321 0.7030365769345003 -7.207431772628461e-08 -0.0977047025718692 -1.4666000000000001 0.703039690896192 0.7030378028434183 -7.868722302906139e-08 -0.09770539184046086 -1.4667000000000001 0.7030409155864557 0.7030390284569665 -8.529005228376935e-08 -0.09770608090446964 -1.4668 0.703042139840556 0.7030402537751261 -9.188130213871187e-08 -0.09770676976395473 -1.4669 0.7030433636587418 0.703041478797863 -9.845947230007618e-08 -0.09770745841897549 -1.467 0.7030445870412781 0.703042703525127 -1.0502306588017901e-07 -0.09770814686959114 -1.4671 0.7030458099884456 0.7030439279568519 -1.1157058973747247e-07 -0.0977088351158609 -1.4672 0.7030470325005407 0.7030451520929547 -1.1810055481481507e-07 -0.09770952315784392 -1.4673000000000003 0.7030482545778762 0.7030463759333379 -1.2461147647600812e-07 -0.09771021099559951 -1.4674 0.7030494762207804 0.7030475994778873 -1.311018748544751e-07 -0.09771089862918683 -1.4675 0.7030506974295969 0.7030488227264733 -1.3757027517505294e-07 -0.097711586058665 -1.4676000000000002 0.7030519182046857 0.7030500456789504 -1.4401520809746715e-07 -0.09771227328409321 -1.4677 0.7030531385464216 0.7030512683351572 -1.504352100372558e-07 -0.09771296030553056 -1.4678000000000002 0.7030543584551955 0.7030524906949172 -1.5682882352138772e-07 -0.09771364712303615 -1.4679 0.7030555779314136 0.7030537127580382 -1.631945975005128e-07 -0.0977143337366691 -1.468 0.7030567969754975 0.7030549345243124 -1.6953108768376357e-07 -0.09771502014648856 -1.4681000000000002 0.7030580155878842 0.7030561559935171 -1.7583685686314854e-07 -0.09771570635255356 -1.4682 0.7030592337690253 0.7030573771654135 -1.8211047524488433e-07 -0.09771639235492308 -1.4683000000000002 0.7030604515193888 0.7030585980397481 -1.8835052077725845e-07 -0.09771707815365621 -1.4684000000000001 0.7030616688394568 0.7030598186162524 -1.945555794628795e-07 -0.09771776374881198 -1.4685 0.7030628857297263 0.7030610388946427 -2.007242456865399e-07 -0.09771844914044941 -1.4686000000000001 0.7030641021907098 0.7030622588746203 -2.0685512249624116e-07 -0.09771913432862744 -1.4687000000000001 0.7030653182229342 0.7030634785558714 -2.1294682201605797e-07 -0.09771981931340508 -1.4688 0.7030665338269411 0.7030646979380679 -2.1899796565777452e-07 -0.09772050409484123 -1.4689 0.7030677490032871 0.7030659170208673 -2.2500718448170698e-07 -0.09772118867299495 -1.469 0.7030689637525427 0.7030671358039114 -2.3097311948119814e-07 -0.09772187304792503 -1.4691 0.703070178075293 0.703068354286829 -2.3689442192609267e-07 -0.09772255721969046 -1.4692 0.7030713919721372 0.7030695724692337 -2.427697536507012e-07 -0.09772324118835007 -1.4693000000000003 0.7030726054436891 0.7030707903507254 -2.4859778731400883e-07 -0.09772392495396282 -1.4694 0.7030738184905758 0.703072007930889 -2.543772068056005e-07 -0.09772460851658743 -1.4695 0.7030750311134388 0.7030732252092965 -2.601067074087249e-07 -0.09772529187628283 -1.4696000000000002 0.7030762433129336 0.7030744421855057 -2.6578499621315865e-07 -0.09772597503310787 -1.4697 0.7030774550897285 0.7030756588590605 -2.7141079231990384e-07 -0.09772665798712127 -1.4698000000000002 0.7030786664445063 0.7030768752294918 -2.769828271811936e-07 -0.09772734073838193 -1.4699 0.7030798773779622 0.7030780912963164 -2.824998448849869e-07 -0.09772802328694855 -1.47 0.7030810878908051 0.7030793070590381 -2.879606023874215e-07 -0.09772870563287987 -1.4701000000000002 0.7030822979837574 0.7030805225171477 -2.9336386984935015e-07 -0.09772938777623473 -1.4702 0.7030835076575537 0.7030817376701226 -2.9870843090695764e-07 -0.0977300697170718 -1.4703000000000002 0.703084716912942 0.7030829525174278 -3.039930829076831e-07 -0.0977307514554498 -1.4704000000000002 0.7030859257506826 0.7030841670585151 -3.0921663722593973e-07 -0.09773143299142739 -1.4705 0.7030871341715487 0.703085381292824 -3.143779195025065e-07 -0.09773211432506336 -1.4706000000000001 0.7030883421763248 0.7030865952197819 -3.1947576990126736e-07 -0.09773279545641622 -1.4707000000000001 0.7030895497658088 0.7030878088388035 -3.245090434145226e-07 -0.09773347638554475 -1.4708 0.70309075694081 0.7030890221492915 -3.294766100503388e-07 -0.09773415711250749 -1.4709 0.7030919637021498 0.7030902351506367 -3.3437735517949374e-07 -0.09773483763736308 -1.471 0.7030931700506611 0.7030914478422186 -3.3921017965343747e-07 -0.09773551796017016 -1.4711 0.7030943759871886 0.7030926602234042 -3.439740002067482e-07 -0.09773619808098727 -1.4712 0.7030955815125878 0.7030938722935502 -3.486677495889712e-07 -0.09773687799987302 -1.4713000000000003 0.703096786627726 0.7030950840520009 -3.53290376821358e-07 -0.09773755771688589 -1.4714 0.703097991333481 0.7030962954980903 -3.578408474952388e-07 -0.09773823723208443 -1.4715 0.7030991956307422 0.7030975066311413 -3.623181438899836e-07 -0.09773891654552722 -1.4716000000000002 0.7031003995204086 0.7030987174504663 -3.667212653130081e-07 -0.0977395956572727 -1.4717 0.7031016030033904 0.7030999279553667 -3.7104922826630693e-07 -0.09774027456737938 -1.4718000000000002 0.7031028060806077 0.7031011381451342 -3.753010666684986e-07 -0.09774095327590575 -1.4719 0.703104008752991 0.7031023480190499 -3.794758321254421e-07 -0.0977416317829102 -1.472 0.7031052110214802 0.7031035575763851 -3.8357259399268706e-07 -0.09774231008845125 -1.4721000000000002 0.7031064128870256 0.7031047668164012 -3.87590439812624e-07 -0.09774298819258728 -1.4722 0.703107614350586 0.7031059757383502 -3.9152847527978984e-07 -0.09774366609537662 -1.4723000000000002 0.7031088154131309 0.703107184341475 -3.953858246016906e-07 -0.09774434379687781 -1.4724000000000002 0.7031100160756374 0.7031083926250088 -3.991616306445178e-07 -0.09774502129714911 -1.4725 0.7031112163390925 0.7031096005881761 -4.0285505509968234e-07 -0.09774569859624893 -1.4726000000000001 0.7031124162044916 0.7031108082301927 -4.064652787058587e-07 -0.0977463756942356 -1.4727000000000001 0.7031136156728386 0.7031120155502659 -4.0999150142939644e-07 -0.09774705259116744 -1.4728 0.7031148147451455 0.7031132225475942 -4.1343294257534247e-07 -0.09774772928710271 -1.4729 0.7031160134224329 0.7031144292213687 -4.1678884109275227e-07 -0.09774840578209983 -1.473 0.7031172117057287 0.7031156355707717 -4.200584556093845e-07 -0.09774908207621694 -1.4731 0.703118409596069 0.7031168415949787 -4.2324106465374545e-07 -0.09774975816951241 -1.4732 0.7031196070944965 0.703118047293157 -4.263359668077449e-07 -0.09775043406204442 -1.4733000000000003 0.7031208042020618 0.7031192526644667 -4.2934248088016824e-07 -0.09775110975387118 -1.4734 0.7031220009198228 0.7031204577080613 -4.322599460246379e-07 -0.09775178524505096 -1.4735 0.7031231972488432 0.7031216624230869 -4.350877219269633e-07 -0.09775246053564188 -1.4736000000000002 0.703124393190194 0.7031228668086836 -4.3782518886759103e-07 -0.0977531356257022 -1.4737 0.7031255887449523 0.7031240708639845 -4.404717479297715e-07 -0.09775381051529006 -1.4738000000000002 0.7031267839142017 0.7031252745881167 -4.43026821138337e-07 -0.09775448520446361 -1.4739 0.7031279786990309 0.7031264779802016 -4.454898515152128e-07 -0.09775515969328097 -1.474 0.7031291731005349 0.7031276810393543 -4.478603032528894e-07 -0.09775583398180024 -1.4741000000000002 0.7031303671198139 0.7031288837646853 -4.501376618462616e-07 -0.09775650807007955 -1.4742 0.7031315607579736 0.7031300861552988 -4.5232143414120074e-07 -0.09775718195817697 -1.4743000000000002 0.7031327540161243 0.7031312882102949 -4.544111485219049e-07 -0.0977578556461506 -1.4744000000000002 0.7031339468953812 0.7031324899287679 -4.5640635489702097e-07 -0.09775852913405843 -1.4745 0.7031351393968643 0.7031336913098085 -4.583066249078116e-07 -0.09775920242195858 -1.4746000000000001 0.7031363315216972 0.7031348923525023 -4.6011155199060516e-07 -0.09775987550990896 -1.4747000000000001 0.7031375232710082 0.7031360930559313 -4.6182075143924584e-07 -0.09776054839796765 -1.4748 0.7031387146459294 0.7031372934191735 -4.634338605022381e-07 -0.09776122108619265 -1.4749 0.703139905647596 0.7031384934413029 -4.6495053843131906e-07 -0.09776189357464185 -1.475 0.7031410962771469 0.7031396931213905 -4.6637046664799175e-07 -0.0977625658633733 -1.4751 0.7031422865357242 0.7031408924585042 -4.676933486463808e-07 -0.09776323795244492 -1.4752 0.7031434764244724 0.7031420914517086 -4.6891891022221577e-07 -0.09776390984191459 -1.4753000000000003 0.7031446659445393 0.7031432901000658 -4.7004689941732014e-07 -0.09776458153184026 -1.4754 0.7031458550970745 0.7031444884026353 -4.710770866514502e-07 -0.09776525302227979 -1.4755 0.7031470438832301 0.7031456863584746 -4.7200926466678395e-07 -0.09776592431329106 -1.4756000000000002 0.70314823230416 0.7031468839666393 -4.728432486666989e-07 -0.09776659540493197 -1.4757 0.7031494203610199 0.7031480812261827 -4.735788763157722e-07 -0.09776726629726032 -1.4758000000000002 0.7031506080549668 0.7031492781361569 -4.7421600776753614e-07 -0.09776793699033391 -1.4759 0.7031517953871587 0.7031504746956133 -4.747545256436614e-07 -0.09776860748421062 -1.476 0.7031529823587552 0.7031516709036016 -4.751943351866128e-07 -0.0977692777789482 -1.4761000000000002 0.7031541689709159 0.7031528667591711 -4.755353641139326e-07 -0.0977699478746045 -1.4762 0.7031553552248011 0.7031540622613702 -4.757775627500793e-07 -0.09777061777123719 -1.4763000000000002 0.7031565411215719 0.7031552574092473 -4.759209039709167e-07 -0.0977712874689041 -1.4764000000000002 0.7031577266623883 0.7031564522018507 -4.759653832175914e-07 -0.09777195696766289 -1.4765 0.703158911848411 0.7031576466382289 -4.7591101851041095e-07 -0.09777262626757131 -1.4766000000000001 0.7031600966807998 0.7031588407174306 -4.757578503794546e-07 -0.09777329536868706 -1.4767000000000001 0.703161281160714 0.7031600344385056 -4.7550594193396245e-07 -0.09777396427106787 -1.4768000000000001 0.7031624652893114 0.7031612278005042 -4.751553788068241e-07 -0.09777463297477133 -1.4769 0.7031636490677493 0.703162420802478 -4.747062690782511e-07 -0.09777530147985512 -1.477 0.7031648324971831 0.7031636134434803 -4.7415874328271546e-07 -0.09777596978637691 -1.4771 0.7031660155787667 0.7031648057225655 -4.735129544228278e-07 -0.09777663789439434 -1.4772 0.7031671983136516 0.7031659976387901 -4.727690778444371e-07 -0.09777730580396492 -1.4773000000000003 0.7031683807029878 0.7031671891912128 -4.7192731125744736e-07 -0.09777797351514629 -1.4774 0.7031695627479226 0.7031683803788946 -4.709878746247953e-07 -0.09777864102799604 -1.4775 0.7031707444496007 0.7031695712008987 -4.6995101014857266e-07 -0.09777930834257167 -1.4776000000000002 0.703171925809164 0.7031707616562923 -4.6881698221451495e-07 -0.09777997545893083 -1.4777 0.7031731068277508 0.7031719517441442 -4.67586077294857e-07 -0.09778064237713095 -1.4778000000000002 0.7031742875064967 0.7031731414635272 -4.66258603878944e-07 -0.09778130909722957 -1.4779 0.7031754678465334 0.7031743308135175 -4.6483489242465925e-07 -0.0977819756192842 -1.478 0.7031766478489887 0.7031755197931956 -4.633152952057684e-07 -0.0977826419433523 -1.4781000000000002 0.7031778275149866 0.703176708401645 -4.617001863743697e-07 -0.09778330806949136 -1.4782 0.7031790068456465 0.703177896637954 -4.5998996171109363e-07 -0.09778397399775877 -1.4783000000000002 0.7031801858420835 0.7031790845012156 -4.581850386042863e-07 -0.09778463972821197 -1.4784000000000002 0.7031813645054079 0.7031802719905269 -4.5628585595286486e-07 -0.09778530526090841 -1.4785 0.7031825428367253 0.7031814591049903 -4.542928740275398e-07 -0.09778597059590549 -1.4786000000000001 0.7031837208371354 0.7031826458437131 -4.522065743389758e-07 -0.09778663573326055 -1.4787000000000001 0.7031848985077332 0.7031838322058085 -4.500274596169751e-07 -0.09778730067303103 -1.4788000000000001 0.7031860758496078 0.7031850181903946 -4.4775605360231063e-07 -0.09778796541527421 -1.4789 0.7031872528638421 0.7031862037965957 -4.4539290099815387e-07 -0.09778862996004745 -1.479 0.7031884295515134 0.7031873890235418 -4.429385672272135e-07 -0.09778929430740807 -1.4791 0.7031896059136926 0.7031885738703699 -4.403936383970408e-07 -0.09778995845741341 -1.4792 0.7031907819514437 0.7031897583362223 -4.37758721105741e-07 -0.09779062241012065 -1.4793000000000003 0.7031919576658242 0.7031909424202492 -4.3503444233788935e-07 -0.09779128616558716 -1.4794 0.7031931330578848 0.7031921261216069 -4.322214492841203e-07 -0.09779194972387018 -1.4795 0.7031943081286687 0.7031933094394593 -4.293204092092884e-07 -0.0977926130850269 -1.4796 0.7031954828792117 0.7031944923729774 -4.263320093067513e-07 -0.0977932762491146 -1.4797 0.7031966573105428 0.7031956749213397 -4.2325695645550887e-07 -0.0977939392161905 -1.4798000000000002 0.7031978314236819 0.7031968570837328 -4.2009597713693614e-07 -0.09779460198631178 -1.4799 0.7031990052196415 0.7031980388593506 -4.168498172404944e-07 -0.09779526455953556 -1.48 0.7032001786994262 0.7031992202473958 -4.1351924193883116e-07 -0.09779592693591904 -1.4801000000000002 0.7032013518640318 0.7032004012470794 -4.101050353547131e-07 -0.09779658911551943 -1.4802 0.7032025247144454 0.7032015818576207 -4.066080005610262e-07 -0.09779725109839381 -1.4803000000000002 0.7032036972516453 0.7032027620782478 -4.0302895928240323e-07 -0.09779791288459923 -1.4804000000000002 0.703204869476601 0.7032039419081979 -3.993687517009348e-07 -0.09779857447419288 -1.4805 0.7032060413902725 0.7032051213467174 -3.956282363312691e-07 -0.09779923586723177 -1.4806000000000001 0.7032072129936107 0.703206300393062 -3.918082897291786e-07 -0.09779989706377301 -1.4807000000000001 0.7032083842875565 0.7032074790464967 -3.879098063805375e-07 -0.09780055806387364 -1.4808000000000001 0.7032095552730413 0.7032086573062968 -3.8393369841682734e-07 -0.09780121886759072 -1.4809 0.7032107259509865 0.7032098351717471 -3.798808954139088e-07 -0.09780187947498122 -1.481 0.7032118963223031 0.7032110126421426 -3.7575234421854953e-07 -0.09780253988610219 -1.4811 0.703213066387892 0.7032121897167884 -3.7154900870556284e-07 -0.09780320010101057 -1.4812 0.7032142361486435 0.7032133663950006 -3.672718695141297e-07 -0.09780386011976339 -1.4813000000000003 0.7032154056054373 0.7032145426761054 -3.629219238743264e-07 -0.09780451994241755 -1.4814 0.7032165747591419 0.70321571855944 -3.585001853642633e-07 -0.09780517956903001 -1.4815 0.703217743610615 0.7032168940443526 -3.540076836186512e-07 -0.09780583899965768 -1.4816 0.7032189121607031 0.7032180691302029 -3.4944546419696243e-07 -0.09780649823435754 -1.4817 0.7032200804102413 0.7032192438163613 -3.448145881948528e-07 -0.09780715727318641 -1.4818000000000002 0.7032212483600528 0.7032204181022101 -3.4011613214701697e-07 -0.09780781611620121 -1.4819 0.7032224160109497 0.703221591987143 -3.353511876663662e-07 -0.09780847476345873 -1.482 0.7032235833637319 0.7032227654705658 -3.305208612774946e-07 -0.09780913321501591 -1.4821000000000002 0.7032247504191874 0.7032239385518964 -3.2562627407667355e-07 -0.09780979147092955 -1.4822 0.7032259171780917 0.7032251112305641 -3.206685615445015e-07 -0.09781044953125645 -1.4823000000000002 0.7032270836412082 0.7032262835060112 -3.1564887323365376e-07 -0.09781110739605342 -1.4824000000000002 0.7032282498092877 0.7032274553776919 -3.105683725052044e-07 -0.0978117650653772 -1.4825 0.703229415683069 0.7032286268450736 -3.054282362788263e-07 -0.09781242253928465 -1.4826000000000001 0.7032305812632771 0.7032297979076356 -3.0022965481074637e-07 -0.09781307981783244 -1.4827000000000001 0.7032317465506248 0.7032309685648706 -2.9497383124965637e-07 -0.09781373690107736 -1.4828000000000001 0.7032329115458116 0.703232138816284 -2.8966198156732403e-07 -0.09781439378907603 -1.4829 0.703234076249524 0.7032333086613944 -2.8429533414572883e-07 -0.09781505048188524 -1.483 0.7032352406624354 0.7032344780997342 -2.7887512951685345e-07 -0.09781570697956168 -1.4831 0.7032364047852051 0.7032356471308481 -2.7340262013023087e-07 -0.09781636328216202 -1.4832 0.7032375686184796 0.703236815754295 -2.6787906994008015e-07 -0.09781701938974294 -1.4833000000000003 0.7032387321628915 0.7032379839696474 -2.623057542908147e-07 -0.09781767530236107 -1.4834 0.703239895419059 0.703239151776491 -2.56683959479892e-07 -0.09781833102007301 -1.4835 0.7032410583875868 0.7032403191744261 -2.51014982490666e-07 -0.09781898654293533 -1.4836 0.7032422210690662 0.7032414861630665 -2.453001307460567e-07 -0.09781964187100471 -1.4837 0.7032433834640739 0.70324265274204 -2.3954072174078855e-07 -0.09782029700433773 -1.4838000000000002 0.703244545573172 0.7032438189109887 -2.337380827881208e-07 -0.09782095194299088 -1.4839 0.7032457073969085 0.7032449846695689 -2.2789355070412798e-07 -0.09782160668702072 -1.484 0.7032468689358174 0.7032461500174512 -2.2200847146075509e-07 -0.09782226123648378 -1.4841000000000002 0.7032480301904178 0.7032473149543211 -2.1608419993254802e-07 -0.09782291559143663 -1.4842 0.7032491911612146 0.7032484794798783 -2.101220995462394e-07 -0.09782356975193579 -1.4843000000000002 0.7032503518486974 0.7032496435938371 -2.0412354197543725e-07 -0.09782422371803771 -1.4844000000000002 0.703251512253341 0.7032508072959266 -1.9808990684572203e-07 -0.09782487748979883 -1.4845 0.7032526723756061 0.7032519705858905 -1.92022581380763e-07 -0.09782553106727561 -1.4846000000000001 0.703253832215938 0.7032531334634877 -1.8592296010741527e-07 -0.09782618445052453 -1.4847000000000001 0.7032549917747669 0.7032542959284921 -1.797924445400001e-07 -0.09782683763960202 -1.4848000000000001 0.7032561510525079 0.7032554579806922 -1.736324428611158e-07 -0.09782749063456443 -1.4849 0.7032573100495609 0.7032566196198917 -1.6744436955561104e-07 -0.09782814343546814 -1.485 0.7032584687663113 0.7032577808459102 -1.612296451417028e-07 -0.09782879604236962 -1.4851 0.7032596272031281 0.7032589416585815 -1.5498969581015376e-07 -0.09782944845532515 -1.4852 0.7032607853603656 0.7032601020577549 -1.487259531206958e-07 -0.09783010067439109 -1.4853000000000003 0.7032619432383633 0.7032612620432955 -1.424398536342686e-07 -0.09783075269962381 -1.4854 0.7032631008374439 0.7032624216150836 -1.3613283864240266e-07 -0.0978314045310796 -1.4855 0.7032642581579158 0.7032635807730145 -1.298063537803762e-07 -0.09783205616881474 -1.4856 0.703265415200071 0.7032647395169995 -1.234618487305772e-07 -0.09783270761288551 -1.4857 0.7032665719641868 0.703265897846965 -1.171007768859672e-07 -0.09783335886334824 -1.4858000000000002 0.7032677284505242 0.7032670557628535 -1.1072459499446297e-07 -0.09783400992025912 -1.4859 0.7032688846593289 0.7032682132646221 -1.0433476285882926e-07 -0.09783466078367438 -1.486 0.7032700405908308 0.7032693703522445 -9.793274297672377e-08 -0.09783531145365026 -1.4861000000000002 0.7032711962452443 0.7032705270257097 -9.152000021803858e-08 -0.09783596193024302 -1.4862 0.7032723516227677 0.7032716832850221 -8.509800149356789e-08 -0.09783661221350876 -1.4863000000000002 0.7032735067235841 0.7032728391302019 -7.866821540893076e-08 -0.0978372623035037 -1.4864000000000002 0.7032746615478607 0.7032739945612851 -7.223211192890211e-08 -0.097837912200284 -1.4865 0.7032758160957485 0.7032751495783234 -6.579116205085098e-08 -0.09783856190390576 -1.4866000000000001 0.7032769703673836 0.7032763041813839 -5.934683746343372e-08 -0.09783921141442516 -1.4867000000000001 0.7032781243628854 0.7032774583705501 -5.290061020875661e-08 -0.09783986073189832 -1.4868000000000001 0.7032792780823582 0.70327861214592 -4.645395235180257e-08 -0.09784050985638126 -1.4869 0.7032804315258905 0.7032797655076084 -4.000833563782332e-08 -0.09784115878793015 -1.487 0.7032815846935547 0.7032809184557454 -3.356523116046506e-08 -0.09784180752660099 -1.4871 0.7032827375854076 0.7032820709904766 -2.712610902436477e-08 -0.09784245607244985 -1.4872 0.7032838902014906 0.7032832231119637 -2.0692438011324366e-08 -0.09784310442553279 -1.4873000000000003 0.7032850425418289 0.7032843748203832 -1.4265685243340653e-08 -0.09784375258590577 -1.4874 0.7032861946064324 0.7032855261159285 -7.847315850514208e-09 -0.09784440055362485 -1.4875 0.7032873463952951 0.7032866769988075 -1.4387926362477432e-09 -0.09784504832874599 -1.4876 0.7032884979083955 0.7032878274692443 4.958424257121841e-09 -0.09784569591132516 -1.4877 0.7032896491456966 0.7032889775274782 1.1342877677920915e-08 -0.09784634330141836 -1.4878000000000002 0.7032908001071455 0.7032901271737642 1.7713113801241798e-08 -0.09784699049908147 -1.4879 0.7032919507926743 0.7032912764083725 2.4067682458973894e-08 -0.09784763750437045 -1.488 0.7032931012021987 0.7032924252315889 3.040513747026852e-08 -0.09784828431734116 -1.4881000000000002 0.7032942513356203 0.7032935736437149 3.6724036957258566e-08 -0.09784893093804958 -1.4882 0.7032954011928241 0.7032947216450665 4.3022943698942107e-08 -0.0978495773665515 -1.4883000000000002 0.7032965507736807 0.7032958692359759 4.930042544169788e-08 -0.09785022360290285 -1.4884000000000002 0.7032977000780447 0.7032970164167898 5.555505521934179e-08 -0.09785086964715944 -1.4885 0.703298849105756 0.7032981631878705 6.178541168966323e-08 -0.09785151549937718 -1.4886000000000001 0.703299997856639 0.7032993095495953 6.799007945187951e-08 -0.09785216115961179 -1.4887000000000001 0.7033011463305032 0.7033004555023561 7.416764936755971e-08 -0.09785280662791912 -1.4888000000000001 0.7033022945271434 0.7033016010465605 8.031671888328318e-08 -0.09785345190435496 -1.4889000000000001 0.7033034424463387 0.70330274618263 8.643589235329818e-08 -0.09785409698897503 -1.489 0.7033045900878541 0.7033038909110019 9.252378134483319e-08 -0.09785474188183513 -1.4891 0.7033057374514393 0.7033050352321277 9.857900495902072e-08 -0.097855386582991 -1.4892 0.7033068845368295 0.7033061791464736 1.0460019014141286e-07 -0.09785603109249838 -1.4893000000000003 0.7033080313437454 0.7033073226545205 1.1058597199423148e-07 -0.09785667541041294 -1.4894 0.7033091778718932 0.7033084657567633 1.1653499410596568e-07 -0.09785731953679039 -1.4895 0.7033103241209642 0.7033096084537118 1.2244590882545814e-07 -0.09785796347168636 -1.4896 0.7033114700906362 0.7033107507458898 1.2831737757762474e-07 -0.09785860721515661 -1.4897 0.7033126157805725 0.7033118926338351 1.3414807117223537e-07 -0.09785925076725675 -1.4898000000000002 0.7033137611904214 0.7033130341181 1.3993667009881694e-07 -0.09785989412804236 -1.4899 0.7033149063198184 0.7033141751992504 1.4568186485278134e-07 -0.0978605372975691 -1.49 0.7033160511683845 0.7033153158778664 1.5138235618175622e-07 -0.09786118027589258 -1.4901000000000002 0.7033171957357272 0.7033164561545415 1.5703685541865187e-07 -0.0978618230630684 -1.4902 0.7033183400214399 0.7033175960298826 1.6264408475574754e-07 -0.09786246565915208 -1.4903000000000002 0.7033194840251027 0.7033187355045107 1.6820277754653334e-07 -0.09786310806419918 -1.4904000000000002 0.7033206277462826 0.7033198745790596 1.7371167857632708e-07 -0.09786375027826527 -1.4905 0.7033217711845325 0.7033210132541767 1.791695443537078e-07 -0.09786439230140581 -1.4906000000000001 0.7033229143393933 0.7033221515305228 1.8457514338113268e-07 -0.09786503413367643 -1.4907000000000001 0.7033240572103916 0.7033232894087709 1.8992725645330943e-07 -0.09786567577513254 -1.4908000000000001 0.7033251997970418 0.7033244268896073 1.9522467691740486e-07 -0.0978663172258296 -1.4909000000000001 0.7033263420988454 0.7033255639737309 2.0046621094713113e-07 -0.09786695848582311 -1.491 0.703327484115291 0.7033267006618533 2.0565067779948487e-07 -0.09786759955516847 -1.4911 0.7033286258458558 0.7033278369546987 2.1077691011658906e-07 -0.09786824043392123 -1.4912 0.7033297672900027 0.7033289728530033 2.1584375414426815e-07 -0.09786888112213671 -1.4913000000000003 0.7033309084471844 0.7033301083575152 2.2085007003735946e-07 -0.09786952161987028 -1.4914 0.7033320493168407 0.7033312434689951 2.2579473208522716e-07 -0.09787016192717744 -1.4915 0.7033331898983988 0.703332378188215 2.3067662895809304e-07 -0.09787080204411347 -1.4916 0.7033343301912754 0.703333512515959 2.354946639707145e-07 -0.09787144197073377 -1.4917 0.7033354701948751 0.7033346464530223 2.4024775532871523e-07 -0.09787208170709363 -1.4918000000000002 0.7033366099085911 0.7033357800002116 2.449348363783854e-07 -0.09787272125324843 -1.4919 0.7033377493318052 0.7033369131583449 2.4955485584260417e-07 -0.09787336060925343 -1.492 0.7033388884638883 0.7033380459282513 2.5410677804288406e-07 -0.09787399977516396 -1.4921000000000002 0.7033400273042005 0.7033391783107704 2.5858958315611025e-07 -0.0978746387510353 -1.4922 0.7033411658520907 0.7033403103067527 2.630022673880128e-07 -0.09787527753692264 -1.4923000000000002 0.7033423041068984 0.7033414419170594 2.6734384325766136e-07 -0.09787591613288138 -1.4924000000000002 0.7033434420679512 0.7033425731425615 2.716133398472653e-07 -0.09787655453896661 -1.4925 0.7033445797345674 0.7033437039841406 2.7580980290625723e-07 -0.0978771927552336 -1.4926000000000001 0.7033457171060551 0.703344834442688 2.7993229513578743e-07 -0.09787783078173756 -1.4927000000000001 0.7033468541817124 0.7033459645191055 2.8397989645240207e-07 -0.09787846861853368 -1.4928000000000001 0.7033479909608278 0.7033470942143032 2.879517040366153e-07 -0.0978791062656771 -1.4929000000000001 0.7033491274426806 0.7033482235292015 2.91846832679854e-07 -0.09787974372322296 -1.493 0.7033502636265407 0.7033493524647298 2.9566441495099127e-07 -0.09788038099122648 -1.4931 0.7033513995116688 0.703350481021827 2.994036013420631e-07 -0.09788101806974275 -1.4932 0.7033525350973167 0.7033516092014398 3.0306356048337424e-07 -0.09788165495882685 -1.4933 0.7033536703827272 0.7033527370045243 3.066434793447259e-07 -0.09788229165853385 -1.4934 0.7033548053671357 0.7033538644320452 3.1014256339501056e-07 -0.09788292816891891 -1.4935 0.703355940049768 0.7033549914849746 3.135600367687452e-07 -0.09788356449003703 -1.4936 0.7033570744298427 0.7033561181642933 3.16895142495055e-07 -0.09788420062194331 -1.4937 0.7033582085065699 0.7033572444709901 3.2014714255318433e-07 -0.09788483656469271 -1.4938000000000002 0.7033593422791526 0.7033583704060609 3.233153181708692e-07 -0.09788547231834031 -1.4939 0.703360475746786 0.7033594959705094 3.263989699076042e-07 -0.09788610788294115 -1.494 0.7033616089086578 0.7033606211653461 3.293974178003589e-07 -0.09788674325855018 -1.4941000000000002 0.7033627417639491 0.703361745991589 3.323100015439895e-07 -0.0978873784452223 -1.4942 0.7033638743118338 0.7033628704502624 3.3513608060226074e-07 -0.09788801344301254 -1.4943000000000002 0.7033650065514792 0.7033639945423975 3.3787503442295197e-07 -0.0978886482519758 -1.4944000000000002 0.7033661384820464 0.7033651182690319 3.4052626247255136e-07 -0.09788928287216708 -1.4945 0.7033672701026906 0.7033662416312091 3.430891844444228e-07 -0.09788991730364123 -1.4946000000000002 0.7033684014125601 0.7033673646299787 3.4556324032819496e-07 -0.09789055154645313 -1.4947000000000001 0.7033695324107977 0.7033684872663961 3.4794789063180565e-07 -0.09789118560065768 -1.4948000000000001 0.7033706630965415 0.7033696095415218 3.5024261634680753e-07 -0.0978918194663098 -1.4949000000000001 0.7033717934689234 0.7033707314564224 3.524469192051072e-07 -0.0978924531434643 -1.495 0.7033729235270705 0.7033718530121686 3.545603216859039e-07 -0.09789308663217605 -1.4951 0.7033740532701047 0.7033729742098365 3.5658236720303993e-07 -0.0978937199324998 -1.4952 0.7033751826971439 0.7033740950505063 3.58512620132756e-07 -0.09789435304449041 -1.4953 0.7033763118073009 0.7033752155352632 3.6035066591083575e-07 -0.09789498596820266 -1.4954 0.7033774405996844 0.703376335665196 3.6209611119220053e-07 -0.09789561870369126 -1.4955 0.7033785690733996 0.703377455441398 3.637485838856036e-07 -0.09789625125101108 -1.4956 0.7033796972275475 0.7033785748649655 3.653077331675081e-07 -0.09789688361021676 -1.4957 0.7033808250612255 0.703379693936999 3.667732297110704e-07 -0.09789751578136306 -1.4958000000000002 0.7033819525735285 0.7033808126586019 3.6814476560981246e-07 -0.09789814776450481 -1.4959 0.7033830797635472 0.7033819310308802 3.6942205452333843e-07 -0.09789877955969654 -1.496 0.7033842066303703 0.7033830490549433 3.706048316912125e-07 -0.09789941116699305 -1.4961000000000002 0.7033853331730836 0.7033841667319026 3.71692854057859e-07 -0.09790004258644891 -1.4962 0.7033864593907704 0.7033852840628725 3.726859001892957e-07 -0.09790067381811884 -1.4963000000000002 0.7033875852825124 0.7033864010489688 3.735837705021172e-07 -0.09790130486205748 -1.4964000000000002 0.7033887108473886 0.7033875176913096 3.743862871455339e-07 -0.0979019357183194 -1.4965 0.7033898360844768 0.7033886339910143 3.7509329407769965e-07 -0.09790256638695922 -1.4966000000000002 0.7033909609928537 0.7033897499492037 3.757046571559175e-07 -0.09790319686803158 -1.4967000000000001 0.703392085571594 0.703390865567 3.7622026406725073e-07 -0.09790382716159103 -1.4968000000000001 0.7033932098197722 0.7033919808455265 3.7664002445342293e-07 -0.09790445726769215 -1.4969000000000001 0.7033943337364613 0.7033930957859065 3.7696386983449015e-07 -0.09790508718638943 -1.497 0.7033954573207346 0.7033942103892641 3.771917536504743e-07 -0.09790571691773746 -1.4971 0.7033965805716645 0.7033953246567236 3.773236512752409e-07 -0.09790634646179071 -1.4972 0.7033977034883239 0.7033964385894094 3.773595599956825e-07 -0.0979069758186037 -1.4973 0.7033988260697854 0.7033975521884452 3.772994990325351e-07 -0.09790760498823095 -1.4974 0.7033999483151224 0.7033986654549551 3.771435095265008e-07 -0.0979082339707269 -1.4975 0.7034010702234088 0.7033997783900614 3.76891654489675e-07 -0.09790886276614603 -1.4976 0.7034021917937195 0.7034008909948859 3.7654401882636357e-07 -0.09790949137454275 -1.4977 0.7034033130251303 0.7034020032705497 3.7610070928451034e-07 -0.09791011979597146 -1.4978000000000002 0.7034044339167189 0.7034031152181717 3.7556185442100265e-07 -0.09791074803048666 -1.4979 0.7034055544675641 0.7034042268388694 3.749276045808547e-07 -0.09791137607814268 -1.498 0.7034066746767467 0.7034053381337584 3.741981318486354e-07 -0.09791200393899392 -1.4981000000000002 0.7034077945433492 0.7034064491039524 3.7337363000683466e-07 -0.09791263161309471 -1.4982 0.7034089140664576 0.7034075597505625 3.724543144942305e-07 -0.09791325910049947 -1.4983000000000002 0.7034100332451588 0.7034086700746973 3.71440422322622e-07 -0.09791388640126247 -1.4984000000000002 0.7034111520785439 0.7034097800774628 3.7033221204907374e-07 -0.09791451351543809 -1.4985 0.703412270565706 0.7034108897599615 3.691299636787715e-07 -0.09791514044308063 -1.4986000000000002 0.7034133887057417 0.7034119991232927 3.678339786511442e-07 -0.09791576718424432 -1.4987000000000001 0.7034145064977515 0.7034131081685524 3.6644457968026956e-07 -0.09791639373898348 -1.4988000000000001 0.7034156239408391 0.7034142168968331 3.6496211073405727e-07 -0.09791702010735243 -1.4989000000000001 0.703416741034112 0.7034153253092226 3.6338693695792124e-07 -0.09791764628940525 -1.499 0.7034178577766821 0.7034164334068052 3.617194445429406e-07 -0.09791827228519626 -1.4991 0.7034189741676655 0.7034175411906607 3.5996004068422627e-07 -0.09791889809477972 -1.4992 0.7034200902061831 0.7034186486618637 3.5810915340050986e-07 -0.09791952371820974 -1.4993 0.7034212058913604 0.7034197558214845 3.5616723152720464e-07 -0.09792014915554054 -1.4994 0.7034223212223278 0.7034208626705886 3.5413474452905547e-07 -0.0979207744068263 -1.4995 0.7034234361982215 0.7034219692102355 3.520121824723832e-07 -0.0979213994721212 -1.4996 0.7034245508181824 0.7034230754414798 3.4980005580997897e-07 -0.09792202435147936 -1.4997 0.7034256650813577 0.7034241813653697 3.474988953047764e-07 -0.09792264904495487 -1.4998000000000002 0.7034267789869 0.703425286982948 3.4510925192576813e-07 -0.09792327355260191 -1.4999 0.7034278925339681 0.7034263922952515 3.426316966745335e-07 -0.09792389787447452 -1.5 0.7034290057217274 0.7034274973033094 3.4006682046033854e-07 -0.09792452201062672 -1.5001000000000002 0.7034301185493494 0.7034286020081464 3.3741523398911344e-07 -0.09792514596111264 -1.5002 0.7034312310160128 0.7034297064107784 3.3467756761079714e-07 -0.09792576972598634 -1.5003000000000002 0.7034323431209031 0.7034308105122157 3.318544711181093e-07 -0.09792639330530184 -1.5004000000000002 0.7034334548632128 0.7034319143134606 3.289466136424668e-07 -0.09792701669911323 -1.5005 0.7034345662421417 0.7034330178155086 3.259546834805116e-07 -0.09792763990747444 -1.5006000000000002 0.7034356772568973 0.7034341210193465 3.2287938794839377e-07 -0.09792826293043938 -1.5007000000000001 0.703436787906695 0.7034352239259547 3.1972145320829926e-07 -0.09792888576806218 -1.5008000000000001 0.7034378981907575 0.7034363265363047 3.1648162404640523e-07 -0.09792950842039669 -1.5009000000000001 0.7034390081083166 0.7034374288513598 3.131606637896134e-07 -0.0979301308874969 -1.501 0.7034401176586119 0.7034385308720756 3.097593540904442e-07 -0.09793075316941674 -1.5011 0.7034412268408915 0.7034396325993981 3.062784946425423e-07 -0.0979313752662101 -1.5012 0.7034423356544124 0.7034407340342651 3.027189031945543e-07 -0.09793199717793086 -1.5013 0.7034434440984405 0.7034418351776057 2.9908141514073394e-07 -0.097932618904633 -1.5014 0.703444552172251 0.7034429360303391 2.9536688349318663e-07 -0.0979332404463703 -1.5015 0.7034456598751279 0.7034440365933758 2.915761785973747e-07 -0.09793386180319669 -1.5016 0.7034467672063649 0.7034451368676163 2.877101879586452e-07 -0.09793448297516591 -1.5017 0.7034478741652657 0.7034462368539516 2.8376981603406293e-07 -0.09793510396233185 -1.5018000000000002 0.7034489807511434 0.7034473365532627 2.7975598397567136e-07 -0.09793572476474828 -1.5019 0.7034500869633216 0.7034484359664208 2.756696294986538e-07 -0.09793634538246906 -1.502 0.7034511928011331 0.7034495350942864 2.7151170659683865e-07 -0.0979369658155479 -1.5021000000000002 0.7034522982639221 0.7034506339377102 2.6728318532759365e-07 -0.09793758606403857 -1.5022 0.7034534033510431 0.7034517324975317 2.6298505161059804e-07 -0.09793820612799486 -1.5023000000000002 0.703454508061861 0.70345283077458 2.5861830697110344e-07 -0.0979388260074705 -1.5024000000000002 0.7034556123957518 0.7034539287696732 2.5418396833870593e-07 -0.09793944570251917 -1.5025 0.7034567163521024 0.7034550264836184 2.496830677975459e-07 -0.09794006521319464 -1.5026000000000002 0.7034578199303109 0.703456123917211 2.451166523434467e-07 -0.09794068453955052 -1.5027000000000001 0.7034589231297865 0.7034572210712358 2.404857835924812e-07 -0.09794130368164052 -1.5028000000000001 0.7034600259499505 0.7034583179464655 2.3579153762831595e-07 -0.09794192263951829 -1.5029000000000001 0.7034611283902353 0.7034594145436615 2.3103500470383898e-07 -0.0979425414132375 -1.503 0.7034622304500853 0.7034605108635723 2.2621728895666493e-07 -0.0979431600028517 -1.5031 0.7034633321289571 0.7034616069069359 2.2133950824260173e-07 -0.09794377840841462 -1.5032 0.7034644334263189 0.7034627026744775 2.164027937540114e-07 -0.09794439662997984 -1.5033 0.7034655343416512 0.7034637981669098 2.1140828986715432e-07 -0.09794501466760087 -1.5034 0.703466634874447 0.7034648933849332 2.0635715380912245e-07 -0.09794563252133133 -1.5035 0.703467735024212 0.7034659883292361 2.0125055544273351e-07 -0.09794625019122481 -1.5036 0.7034688347904638 0.703467083000493 1.9608967692999468e-07 -0.09794686767733475 -1.5037 0.7034699341727337 0.7034681773993671 1.90875712541283e-07 -0.09794748497971478 -1.5038000000000002 0.7034710331705654 0.7034692715265074 1.856098682979923e-07 -0.09794810209841837 -1.5039 0.7034721317835151 0.7034703653825507 1.8029336174354982e-07 -0.09794871903349896 -1.504 0.7034732300111531 0.7034714589681201 1.7492742164851305e-07 -0.0979493357850101 -1.5041000000000002 0.7034743278530624 0.7034725522838259 1.6951328770872798e-07 -0.09794995235300524 -1.5042 0.7034754253088393 0.7034736453302644 1.6405221030246775e-07 -0.09795056873753787 -1.5043000000000002 0.7034765223780941 0.7034747381080187 1.585454501677741e-07 -0.0979511849386614 -1.5044000000000002 0.7034776190604497 0.7034758306176583 1.5299427811102384e-07 -0.09795180095642919 -1.5045 0.7034787153555435 0.703476922859739 1.4739997474325084e-07 -0.09795241679089473 -1.5046000000000002 0.7034798112630263 0.7034780148348025 1.4176383013667082e-07 -0.09795303244211133 -1.5047000000000001 0.7034809067825627 0.7034791065433771 1.3608714356447282e-07 -0.09795364791013242 -1.5048000000000001 0.7034820019138317 0.7034801979859765 1.30371223219794e-07 -0.09795426319501133 -1.5049000000000001 0.7034830966565261 0.7034812891631004 1.2461738584795823e-07 -0.09795487829680144 -1.505 0.7034841910103526 0.703482380075235 1.1882695648973707e-07 -0.0979554932155561 -1.5051 0.7034852849750326 0.7034834707228513 1.1300126820379397e-07 -0.09795610795132859 -1.5052 0.7034863785503014 0.7034845611064063 1.0714166167463679e-07 -0.09795672250417221 -1.5053 0.703487471735909 0.7034856512263425 1.0124948499404263e-07 -0.09795733687414027 -1.5054 0.7034885645316196 0.7034867410830881 9.5326093289827e-08 -0.09795795106128598 -1.5055 0.7034896569372122 0.7034878306770566 8.937284843441029e-08 -0.09795856506566272 -1.5056 0.70349074895248 0.7034889200086465 8.339111874297589e-08 -0.09795917888732363 -1.5057 0.7034918405772315 0.7034900090782419 7.738227865775049e-08 -0.09795979252632198 -1.5058000000000002 0.7034929318112895 0.7034910978862121 7.134770841320248e-08 -0.09796040598271094 -1.5059 0.7034940226544915 0.7034921864329117 6.52887937237917e-08 -0.0979610192565438 -1.506 0.7034951131066899 0.70349327471868 5.920692548733175e-08 -0.09796163234787361 -1.5061000000000002 0.7034962031677525 0.7034943627438419 5.3103499438045265e-08 -0.0979622452567537 -1.5062 0.7034972928375615 0.7034954505087065 4.69799158481915e-08 -0.09796285798323712 -1.5063000000000002 0.7034983821160141 0.7034965380135686 4.083757918979525e-08 -0.09796347052737699 -1.5064000000000002 0.7034994710030227 0.7034976252587075 3.467789782760078e-08 -0.09796408288922648 -1.5065 0.7035005594985149 0.7034987122443875 2.8502283691209107e-08 -0.0979646950688387 -1.5066000000000002 0.7035016476024332 0.7034997989708579 2.231215194027636e-08 -0.09796530706626672 -1.5067000000000002 0.7035027353147352 0.7035008854383527 1.610892065313091e-08 -0.09796591888156367 -1.5068000000000001 0.7035038226353938 0.7035019716470905 9.894010505849538e-09 -0.09796653051478256 -1.5069000000000001 0.703504909564397 0.7035030575972747 3.668844431384266e-09 -0.0979671419659765 -1.507 0.7035059961017482 0.7035041432890939 -2.5651526935552282e-09 -0.09796775323519846 -1.5071 0.7035070822474655 0.703505228722721 -8.806554379833798e-09 -0.0979683643225015 -1.5072 0.7035081680015828 0.7035063138983135 -1.5053932849850432e-08 -0.09796897522793861 -1.5073 0.703509253364149 0.7035073988160138 -2.1305859368436764e-08 -0.09796958595156278 -1.5074 0.7035103383352284 0.7035084834759491 -2.7560904560745142e-08 -0.09797019649342702 -1.5075 0.7035114229149002 0.7035095678782313 -3.381763874835131e-08 -0.09797080685358427 -1.5076 0.7035125071032594 0.7035106520229566 -4.0074632272021384e-08 -0.09797141703208749 -1.5077 0.7035135909004155 0.7035117359102062 -4.6330455816321996e-08 -0.09797202702898958 -1.5078000000000003 0.7035146743064942 0.7035128195400461 -5.25836807384588e-08 -0.09797263684434346 -1.5079 0.7035157573216354 0.7035139029125266 -5.883287939570554e-08 -0.09797324647820205 -1.508 0.703516839945995 0.7035149860276834 -6.507662546773735e-08 -0.09797385593061825 -1.5081000000000002 0.7035179221797441 0.7035160688855364 -7.131349428297559e-08 -0.09797446520164493 -1.5082 0.7035190040230681 0.7035171514860903 -7.754206314720957e-08 -0.09797507429133495 -1.5083000000000002 0.7035200854761687 0.7035182338293349 -8.376091166408667e-08 -0.09797568319974113 -1.5084000000000002 0.7035211665392618 0.7035193159152442 -8.996862205755407e-08 -0.09797629192691627 -1.5085 0.703522247212579 0.7035203977437781 -9.616377950449201e-08 -0.09797690047291328 -1.5086000000000002 0.7035233274963668 0.7035214793148803 -1.0234497244219348e-07 -0.09797750883778487 -1.5087000000000002 0.7035244073908866 0.7035225606284803 -1.085107929031659e-07 -0.09797811702158392 -1.5088000000000001 0.7035254868964146 0.7035236416844919 -1.1465983682651393e-07 -0.09797872502436311 -1.5089000000000001 0.7035265660132424 0.7035247224828143 -1.2079070438320016e-07 -0.09797933284617523 -1.509 0.7035276447416761 0.7035258030233316 -1.269020003004384e-07 -0.09797994048707305 -1.5091 0.7035287230820367 0.7035268833059131 -1.3299233415399458e-07 -0.09798054794710923 -1.5092 0.7035298010346602 0.703527963330413 -1.390603207220703e-07 -0.0979811552263365 -1.5093 0.7035308785998973 0.7035290430966716 -1.4510458026285866e-07 -0.09798176232480764 -1.5094 0.7035319557781128 0.7035301226045132 -1.5112373885975416e-07 -0.0979823692425752 -1.5095 0.7035330325696867 0.7035312018537488 -1.5711642871625575e-07 -0.09798297597969198 -1.5096 0.7035341089750131 0.7035322808441737 -1.6308128846995174e-07 -0.09798358253621055 -1.5097 0.7035351849945012 0.7035333595755691 -1.6901696349262696e-07 -0.09798418891218352 -1.5098000000000003 0.7035362606285737 0.703534438047702 -1.749221062233297e-07 -0.09798479510766359 -1.5099 0.7035373358776683 0.703535516260325 -1.807953764407233e-07 -0.09798540112270333 -1.51 0.7035384107422367 0.703536594213176 -1.866354415909488e-07 -0.0979860069573554 -1.5101000000000002 0.7035394852227443 0.7035376719059794 -1.9244097708079333e-07 -0.0979866126116723 -1.5102 0.7035405593196711 0.7035387493384452 -1.982106666159611e-07 -0.09798721808570664 -1.5103000000000002 0.7035416330335107 0.703539826510269 -2.039432023988319e-07 -0.09798782337951094 -1.5104000000000002 0.7035427063647707 0.7035409034211333 -2.0963728553785588e-07 -0.09798842849313773 -1.5105 0.7035437793139724 0.7035419800707059 -2.1529162628000642e-07 -0.09798903342663953 -1.5106000000000002 0.7035448518816505 0.7035430564586419 -2.2090494431609153e-07 -0.0979896381800689 -1.5107000000000002 0.7035459240683541 0.7035441325845819 -2.2647596907218737e-07 -0.09799024275347828 -1.5108000000000001 0.7035469958746448 0.7035452084481535 -2.320034400045412e-07 -0.09799084714692015 -1.5109000000000001 0.7035480673010974 0.7035462840489709 -2.374861068528411e-07 -0.097991451360447 -1.511 0.7035491383483008 0.7035473593866348 -2.429227299871606e-07 -0.09799205539411125 -1.5111 0.7035502090168566 0.7035484344607331 -2.483120806091865e-07 -0.09799265924796532 -1.5112 0.7035512793073794 0.7035495092708404 -2.536529410991639e-07 -0.09799326292206172 -1.5113 0.7035523492204963 0.7035505838165182 -2.5894410523100153e-07 -0.09799386641645273 -1.5114 0.7035534187568474 0.7035516580973158 -2.641843784879916e-07 -0.09799446973119078 -1.5115 0.7035544879170857 0.7035527321127695 -2.6937257831954886e-07 -0.0979950728663283 -1.5116 0.7035555567018763 0.703553805862403 -2.745075343944803e-07 -0.09799567582191764 -1.5117 0.7035566251118968 0.7035548793457278 -2.7958808890629627e-07 -0.09799627859801112 -1.5118000000000003 0.7035576931478367 0.7035559525622429 -2.846130967883165e-07 -0.09799688119466105 -1.5119 0.7035587608103978 0.7035570255114354 -2.8958142597387826e-07 -0.09799748361191973 -1.512 0.7035598281002939 0.7035580981927807 -2.944919576981786e-07 -0.09799808584983959 -1.5121000000000002 0.7035608950182504 0.7035591706057418 -2.9934358667174643e-07 -0.09799868790847278 -1.5122 0.7035619615650044 0.7035602427497704 -3.041352214239179e-07 -0.09799928978787165 -1.5123000000000002 0.7035630277413042 0.7035613146243063 -3.0886578449018653e-07 -0.09799989148808835 -1.5124000000000002 0.7035640935479099 0.7035623862287781 -3.1353421264118664e-07 -0.09800049300917524 -1.5125 0.7035651589855927 0.703563457562604 -3.181394571394325e-07 -0.09800109435118452 -1.5126000000000002 0.7035662240551341 0.7035645286251897 -3.2268048401340454e-07 -0.0980016955141684 -1.5127000000000002 0.7035672887573277 0.7035655994159311 -3.2715627425877747e-07 -0.09800229649817908 -1.5128000000000001 0.7035683530929766 0.7035666699342127 -3.3156582402577017e-07 -0.09800289730326872 -1.5129000000000001 0.7035694170628949 0.7035677401794087 -3.359081448967016e-07 -0.09800349792948951 -1.513 0.7035704806679073 0.7035688101508832 -3.401822641080354e-07 -0.09800409837689363 -1.5131000000000001 0.7035715439088484 0.7035698798479896 -3.443872247307911e-07 -0.09800469864553324 -1.5132 0.7035726067865624 0.7035709492700711 -3.4852208595503864e-07 -0.09800529873546035 -1.5133 0.7035736693019041 0.7035720184164616 -3.5258592320785986e-07 -0.09800589864672715 -1.5134 0.7035747314557378 0.7035730872864848 -3.5657782841008734e-07 -0.09800649837938576 -1.5135 0.7035757932489369 0.7035741558794553 -3.604969101844713e-07 -0.09800709793348825 -1.5136 0.7035768546823843 0.7035752241946778 -3.643422940707852e-07 -0.09800769730908665 -1.5137 0.7035779157569721 0.7035762922314484 -3.6811312264378726e-07 -0.09800829650623304 -1.5138000000000003 0.7035789764736013 0.7035773599890536 -3.718085557630202e-07 -0.09800889552497949 -1.5139 0.7035800368331815 0.703578427466772 -3.7542777078097833e-07 -0.09800949436537801 -1.514 0.703581096836631 0.7035794946638727 -3.789699626957632e-07 -0.09801009302748057 -1.5141000000000002 0.7035821564848765 0.7035805615796166 -3.82434344317617e-07 -0.09801069151133922 -1.5142 0.7035832157788527 0.7035816282132564 -3.858201464562727e-07 -0.0980112898170059 -1.5143000000000002 0.7035842747195027 0.7035826945640372 -3.891266181013653e-07 -0.0980118879445326 -1.5144000000000002 0.7035853333077766 0.7035837606311957 -3.9235302656120963e-07 -0.09801248589397127 -1.5145 0.7035863915446325 0.7035848264139613 -3.9549865768484516e-07 -0.09801308366537383 -1.5146000000000002 0.7035874494310366 0.7035858919115556 -3.9856281592448584e-07 -0.09801368125879226 -1.5147 0.703588506967961 0.7035869571231936 -4.0154482458532037e-07 -0.09801427867427842 -1.5148000000000001 0.7035895641563856 0.7035880220480828 -4.044440259157178e-07 -0.09801487591188421 -1.5149000000000001 0.7035906209972971 0.7035890866854233 -4.072597813153944e-07 -0.09801547297166147 -1.515 0.7035916774916879 0.7035901510344098 -4.0999147137704695e-07 -0.09801606985366212 -1.5151000000000001 0.7035927336405583 0.7035912150942303 -4.1263849607370284e-07 -0.09801666655793807 -1.5152 0.7035937894449131 0.7035922788640658 -4.152002749113759e-07 -0.09801726308454108 -1.5153 0.7035948449057642 0.7035933423430918 -4.17676247074783e-07 -0.09801785943352295 -1.5154 0.7035959000241285 0.703594405530478 -4.20065871441222e-07 -0.09801845560493551 -1.5155 0.7035969548010295 0.7035954684253887 -4.223686268234328e-07 -0.09801905159883059 -1.5156 0.7035980092374945 0.7035965310269827 -4.245840120042921e-07 -0.09801964741525997 -1.5157 0.7035990633345572 0.7035975933344133 -4.267115458964077e-07 -0.09802024305427537 -1.5158000000000003 0.7036001170932549 0.7035986553468296 -4.2875076759069097e-07 -0.09802083851592852 -1.5159 0.703601170514631 0.7035997170633754 -4.307012364951346e-07 -0.09802143380027124 -1.516 0.7036022235997321 0.7036007784831901 -4.32562532438896e-07 -0.09802202890735515 -1.5161000000000002 0.7036032763496101 0.7036018396054093 -4.343342557347474e-07 -0.09802262383723202 -1.5162 0.70360432876532 0.7036029004291637 -4.3601602728315925e-07 -0.09802321858995355 -1.5163000000000002 0.7036053808479208 0.7036039609535811 -4.3760748866944477e-07 -0.09802381316557142 -1.5164000000000002 0.7036064325984754 0.7036050211777849 -4.3910830213600427e-07 -0.09802440756413724 -1.5165 0.7036074840180497 0.7036060811008954 -4.4051815078355316e-07 -0.09802500178570268 -1.5166000000000002 0.703608535107713 0.7036071407220299 -4.4183673857806083e-07 -0.09802559583031942 -1.5167 0.7036095858685374 0.7036082000403029 -4.43063790454834e-07 -0.09802618969803904 -1.5168000000000001 0.7036106363015973 0.7036092590548255 -4.4419905231157797e-07 -0.09802678338891314 -1.5169000000000001 0.70361168640797 0.7036103177647068 -4.4524229109166313e-07 -0.09802737690299337 -1.517 0.7036127361887349 0.7036113761690539 -4.4619329483269743e-07 -0.09802797024033126 -1.5171000000000001 0.703613785644973 0.7036124342669713 -4.470518727081596e-07 -0.09802856340097837 -1.5172 0.7036148347777675 0.7036134920575617 -4.478178550898493e-07 -0.09802915638498623 -1.5173 0.7036158835882032 0.7036145495399267 -4.484910935340092e-07 -0.09802974919240641 -1.5174 0.703616932077366 0.7036156067131664 -4.4907146080908067e-07 -0.09803034182329044 -1.5175 0.7036179802463427 0.7036166635763791 -4.495588509789705e-07 -0.09803093427768977 -1.5176 0.7036190280962212 0.7036177201286631 -4.4995317933366197e-07 -0.09803152655565595 -1.5177 0.7036200756280903 0.7036187763691156 -4.5025438251411476e-07 -0.09803211865724043 -1.5178000000000003 0.7036211228430385 0.7036198322968332 -4.504624184081818e-07 -0.09803271058249467 -1.5179 0.7036221697421549 0.7036208879109128 -4.5057726624775363e-07 -0.09803330233147012 -1.518 0.7036232163265286 0.7036219432104507 -4.5059892650467503e-07 -0.09803389390421818 -1.5181000000000002 0.7036242625972482 0.7036229981945441 -4.5052742100870624e-07 -0.09803448530079038 -1.5182 0.7036253085554018 0.7036240528622898 -4.503627928365006e-07 -0.09803507652123798 -1.5183000000000002 0.7036263542020771 0.7036251072127859 -4.501051063324213e-07 -0.09803566756561244 -1.5184000000000002 0.7036273995383604 0.7036261612451318 -4.497544470738468e-07 -0.09803625843396517 -1.5185 0.7036284445653371 0.7036272149584268 -4.493109219128044e-07 -0.0980368491263475 -1.5186000000000002 0.7036294892840909 0.7036282683517725 -4.4877465884413104e-07 -0.09803743964281073 -1.5187 0.7036305336957038 0.7036293214242721 -4.4814580701241225e-07 -0.09803802998340623 -1.5188000000000001 0.7036315778012567 0.7036303741750302 -4.4742453670504334e-07 -0.09803862014818536 -1.5189000000000001 0.7036326216018275 0.7036314266031536 -4.466110392620237e-07 -0.09803921013719935 -1.519 0.7036336650984922 0.7036324787077517 -4.4570552704126243e-07 -0.09803979995049958 -1.5191000000000001 0.7036347082923242 0.703633530487936 -4.4470823337000587e-07 -0.09804038958813727 -1.5192 0.7036357511843938 0.7036345819428206 -4.4361941251708226e-07 -0.09804097905016362 -1.5193 0.703636793775769 0.703635633071523 -4.4243933953330705e-07 -0.09804156833662997 -1.5194 0.703637836067514 0.7036366838731636 -4.4116831027923853e-07 -0.09804215744758754 -1.5195 0.7036388780606895 0.7036377343468663 -4.3980664133497216e-07 -0.09804274638308749 -1.5196 0.703639919756353 0.7036387844917583 -4.3835466986830163e-07 -0.09804333514318106 -1.5197 0.7036409611555583 0.7036398343069712 -4.36812753558391e-07 -0.0980439237279195 -1.5198000000000003 0.7036420022593544 0.7036408837916399 -4.351812705957747e-07 -0.09804451213735389 -1.5199 0.7036430430687861 0.7036419329449041 -4.3346061954357973e-07 -0.09804510037153541 -1.52 0.7036440835848942 0.7036429817659079 -4.3165121914323645e-07 -0.09804568843051527 -1.5201000000000002 0.7036451238087144 0.7036440302538001 -4.297535083908066e-07 -0.09804627631434458 -1.5202 0.7036461637412771 0.7036450784077339 -4.277679462524886e-07 -0.09804686402307436 -1.5203000000000002 0.7036472033836082 0.7036461262268687 -4.256950117131897e-07 -0.09804745155675582 -1.5204000000000002 0.7036482427367281 0.7036471737103682 -4.235352035406037e-07 -0.09804803891544006 -1.5205 0.7036492818016511 0.703648220857402 -4.212890402296998e-07 -0.0980486260991781 -1.5206000000000002 0.7036503205793863 0.7036492676671455 -4.189570598639447e-07 -0.09804921310802099 -1.5207 0.7036513590709362 0.70365031413878 -4.1653981997652467e-07 -0.0980497999420198 -1.5208000000000002 0.7036523972772976 0.7036513602714931 -4.140378974532011e-07 -0.09805038660122556 -1.5209000000000001 0.7036534351994606 0.7036524060644784 -4.114518883241436e-07 -0.0980509730856893 -1.521 0.7036544728384088 0.7036534515169368 -4.0878240768066343e-07 -0.09805155939546202 -1.5211000000000001 0.7036555101951188 0.7036544966280751 -4.0603008956419107e-07 -0.09805214553059471 -1.5212 0.7036565472705605 0.7036555413971075 -4.0319558668178157e-07 -0.09805273149113833 -1.5213 0.7036575840656962 0.7036565858232557 -4.002795703991757e-07 -0.09805331727714385 -1.5214 0.7036586205814809 0.7036576299057482 -3.9728273045630536e-07 -0.09805390288866223 -1.5215 0.7036596568188621 0.7036586736438213 -3.942057749464767e-07 -0.09805448832574439 -1.5216 0.7036606927787796 0.7036597170367193 -3.9104943001799786e-07 -0.09805507358844127 -1.5217 0.7036617284621645 0.7036607600836938 -3.8781443978397334e-07 -0.09805565867680373 -1.5218000000000003 0.7036627638699404 0.7036618027840054 -3.8450156608638153e-07 -0.09805624359088269 -1.5219 0.7036637990030229 0.703662845136922 -3.8111158837811354e-07 -0.09805682833072904 -1.522 0.7036648338623177 0.7036638871417212 -3.776453035078675e-07 -0.09805741289639361 -1.5221000000000002 0.7036658684487228 0.7036649287976884 -3.74103525498104e-07 -0.09805799728792725 -1.5222 0.7036669027631268 0.7036659701041181 -3.7048708543402364e-07 -0.09805858150538078 -1.5223000000000002 0.7036679368064096 0.703667011060314 -3.667968312484615e-07 -0.09805916554880502 -1.5224000000000002 0.7036689705794418 0.7036680516655892 -3.6303362743045353e-07 -0.0980597494182509 -1.5225 0.7036700040830837 0.7036690919192659 -3.591983549489086e-07 -0.09806033311376902 -1.5226000000000002 0.7036710373181868 0.7036701318206757 -3.5529191097505297e-07 -0.09806091663541025 -1.5227 0.7036720702855928 0.7036711713691605 -3.5131520866732435e-07 -0.09806149998322537 -1.5228000000000002 0.7036731029861327 0.7036722105640718 -3.4726917706034977e-07 -0.09806208315726504 -1.5229000000000001 0.7036741354206284 0.7036732494047713 -3.431547606763674e-07 -0.09806266615758012 -1.523 0.7036751675898905 0.7036742878906306 -3.3897291944195995e-07 -0.09806324898422122 -1.5231000000000001 0.7036761994947198 0.7036753260210321 -3.3472462841743766e-07 -0.09806383163723909 -1.5232 0.7036772311359063 0.7036763637953691 -3.3041087756091603e-07 -0.09806441411668443 -1.5233 0.7036782625142288 0.7036774012130451 -3.2603267149933224e-07 -0.09806499642260791 -1.5234 0.7036792936304559 0.7036784382734744 -3.2159102936191175e-07 -0.0980655785550602 -1.5235 0.7036803244853442 0.7036794749760826 -3.170869844193458e-07 -0.09806616051409191 -1.5236 0.7036813550796401 0.7036805113203066 -3.125215839311357e-07 -0.09806674229975373 -1.5237 0.7036823854140777 0.7036815473055945 -3.0789588892354836e-07 -0.09806732391209624 -1.5238000000000003 0.7036834154893803 0.7036825829314057 -3.032109738079769e-07 -0.09806790535117006 -1.5239 0.703684445306259 0.7036836181972111 -2.984679263393075e-07 -0.09806848661702576 -1.524 0.7036854748654131 0.7036846531024943 -2.9366784713366623e-07 -0.09806906770971394 -1.5241000000000002 0.7036865041675304 0.7036856876467497 -2.8881184959902995e-07 -0.09806964862928519 -1.5242 0.7036875332132861 0.7036867218294841 -2.839010596021596e-07 -0.09807022937578996 -1.5243000000000002 0.7036885620033437 0.7036877556502168 -2.7893661521533053e-07 -0.0980708099492789 -1.5244000000000002 0.7036895905383539 0.7036887891084791 -2.739196664006127e-07 -0.09807139034980249 -1.5245 0.7036906188189553 0.7036898222038146 -2.688513748641541e-07 -0.09807197057741124 -1.5246000000000002 0.7036916468457735 0.7036908549357792 -2.637329136571942e-07 -0.09807255063215559 -1.5247 0.7036926746194219 0.7036918873039424 -2.5856546700259164e-07 -0.09807313051408609 -1.5248000000000002 0.7036937021405009 0.7036929193078856 -2.5335022994441014e-07 -0.09807371022325317 -1.5249000000000001 0.703694729409598 0.7036939509472032 -2.4808840815016e-07 -0.09807428975970736 -1.525 0.7036957564272872 0.7036949822215028 -2.4278121756038384e-07 -0.098074869123499 -1.5251000000000001 0.7036967831941296 0.703696013130405 -2.3742988415620392e-07 -0.09807544831467849 -1.5252000000000001 0.7036978097106737 0.7036970436735436 -2.3203564365054108e-07 -0.09807602733329629 -1.5253 0.7036988359774541 0.7036980738505657 -2.2659974121749804e-07 -0.09807660617940281 -1.5254 0.7036998619949915 0.7036991036611321 -2.2112343119398692e-07 -0.09807718485304842 -1.5255 0.7037008877637937 0.7037001331049163 -2.1560797679523458e-07 -0.09807776335428345 -1.5256 0.7037019132843549 0.7037011621816063 -2.10054649830288e-07 -0.09807834168315831 -1.5257 0.7037029385571554 0.7037021908909029 -2.0446473038976398e-07 -0.09807891983972328 -1.5258000000000003 0.7037039635826614 0.7037032192325215 -1.9883950656829352e-07 -0.0980794978240287 -1.5259 0.7037049883613257 0.7037042472061908 -1.9318027418002703e-07 -0.09808007563612489 -1.526 0.7037060128935866 0.7037052748116535 -1.874883364186286e-07 -0.09808065327606208 -1.5261000000000002 0.703707037179869 0.7037063020486665 -1.8176500361094527e-07 -0.09808123074389068 -1.5262 0.7037080612205835 0.7037073289170004 -1.7601159283883727e-07 -0.0980818080396609 -1.5263000000000002 0.703709085016126 0.7037083554164403 -1.7022942774488903e-07 -0.09808238516342295 -1.5264000000000002 0.7037101085668787 0.7037093815467854 -1.644198381143408e-07 -0.09808296211522714 -1.5265 0.7037111318732088 0.703710407307849 -1.5858415966171768e-07 -0.0980835388951236 -1.5266000000000002 0.7037121549354702 0.703711432699459 -1.5272373365786407e-07 -0.09808411550316262 -1.5267 0.7037131777540018 0.7037124577214574 -1.4683990665759206e-07 -0.0980846919393944 -1.5268000000000002 0.7037142003291277 0.7037134823737006 -1.4093403018396178e-07 -0.09808526820386906 -1.5269000000000001 0.703715222661158 0.70371450665606 -1.35007460410827e-07 -0.09808584429663683 -1.527 0.7037162447503877 0.7037155305684206 -1.29061557862728e-07 -0.09808642021774783 -1.5271000000000001 0.7037172665970981 0.7037165541106831 -1.2309768708702873e-07 -0.09808699596725223 -1.5272000000000001 0.7037182882015545 0.7037175772827617 -1.1711721635901395e-07 -0.09808757154520009 -1.5273 0.7037193095640086 0.7037186000845863 -1.1112151734188336e-07 -0.0980881469516416 -1.5274 0.7037203306846973 0.7037196225161008 -1.0511196481093055e-07 -0.09808872218662688 -1.5275 0.7037213515638416 0.7037206445772635 -9.908993630920043e-08 -0.09808929725020589 -1.5276 0.7037223722016493 0.7037216662680483 -9.305681182916747e-08 -0.09808987214242881 -1.5277 0.7037233925983122 0.7037226875884435 -8.701397352390422e-08 -0.09809044686334564 -1.5278000000000003 0.7037244127540081 0.7037237085384519 -8.096280536187134e-08 -0.09809102141300646 -1.5279 0.7037254326688993 0.7037247291180913 -7.490469282073892e-08 -0.09809159579146126 -1.528 0.7037264523431335 0.7037257493273944 -6.884102257773833e-08 -0.09809216999876005 -1.5281000000000002 0.7037274717768438 0.7037267691664086 -6.277318218396791e-08 -0.0980927440349529 -1.5282 0.7037284909701482 0.703727788635196 -5.670255974867325e-08 -0.09809331790008972 -1.5283000000000002 0.7037295099231495 0.7037288077338342 -5.0630543618973914e-08 -0.09809389159422052 -1.5284 0.7037305286359363 0.7037298264624143 -4.455852207064896e-08 -0.09809446511739522 -1.5285 0.7037315471085819 0.7037308448210435 -3.848788298349971e-08 -0.09809503846966389 -1.5286000000000002 0.7037325653411448 0.7037318628098432 -3.242001352457297e-08 -0.09809561165107632 -1.5287 0.7037335833336686 0.7037328804289495 -2.6356299835531352e-08 -0.09809618466168248 -1.5288000000000002 0.7037346010861827 0.7037338976785139 -2.02981267133015e-08 -0.09809675750153231 -1.5289000000000001 0.7037356185987003 0.7037349145587016 -1.4246877292917876e-08 -0.09809733017067561 -1.529 0.7037366358712212 0.7037359310696936 -8.20393273670908e-09 -0.0980979026691623 -1.5291000000000001 0.7037376529037296 0.7037369472116847 -2.170671912181399e-09 -0.09809847499704222 -1.5292000000000001 0.7037386696961957 0.7037379629848852 3.851528917846181e-09 -0.09809904715436525 -1.5293 0.7037396862485739 0.70373897838952 9.86129641313005e-09 -0.09809961914118119 -1.5294 0.7037407025608051 0.7037399934258278 1.5857260457843858e-08 -0.09810019095753987 -1.5295 0.703741718632815 0.703741008094063 2.1838054487140213e-08 -0.09810076260349117 -1.5296 0.7037427344645144 0.7037420223944935 2.7802315795064092e-08 -0.09810133407908474 -1.5297 0.7037437500558004 0.7037430363274022 3.374868584073154e-08 -0.09810190538437047 -1.5298000000000003 0.7037447654065546 0.7037440498930864 3.967581056231462e-08 -0.09810247651939805 -1.5299 0.7037457805166452 0.703745063091858 4.55823406693423e-08 -0.09810304748421729 -1.53 0.7037467953859251 0.7037460759240427 5.1466931976634767e-08 -0.09810361827887787 -1.5301000000000002 0.7037478100142335 0.7037470883899812 5.73282456801244e-08 -0.09810418890342958 -1.5302 0.7037488244013947 0.7037481004900278 6.316494870726996e-08 -0.09810475935792205 -1.5303000000000002 0.7037498385472195 0.7037491122245512 6.897571396859148e-08 -0.09810532964240501 -1.5304 0.7037508524515039 0.7037501235939342 7.475922068553298e-08 -0.09810589975692811 -1.5305 0.7037518661140307 0.7037511345985736 8.051415467495715e-08 -0.0981064697015411 -1.5306000000000002 0.7037528795345676 0.7037521452388804 8.623920867353863e-08 -0.09810703947629358 -1.5307 0.703753892712869 0.7037531555152788 9.193308263613642e-08 -0.09810760908123513 -1.5308000000000002 0.7037549056486758 0.7037541654282076 9.759448397345105e-08 -0.09810817851641546 -1.5309000000000001 0.7037559183417144 0.7037551749781182 1.0322212791805119e-07 -0.09810874778188411 -1.531 0.703756930791698 0.7037561841654771 1.0881473778284745e-07 -0.09810931687769076 -1.5311000000000001 0.7037579429983261 0.7037571929907631 1.1437104523864816e-07 -0.09810988580388488 -1.5312000000000001 0.7037589549612848 0.703758201454469 1.1988979060906235e-07 -0.09811045456051616 -1.5313 0.7037599666802464 0.7037592095571008 1.2536972319662776e-07 -0.09811102314763404 -1.5314 0.7037609781548708 0.7037602172991777 1.3080960149791654e-07 -0.09811159156528819 -1.5315 0.7037619893848035 0.7037612246812319 1.3620819355394942e-07 -0.09811215981352796 -1.5316 0.7037630003696781 0.7037622317038092 1.415642771583625e-07 -0.098112727892403 -1.5317 0.7037640111091146 0.7037632383674677 1.468766401974131e-07 -0.09811329580196278 -1.5318000000000003 0.7037650216027201 0.7037642446727785 1.5214408085814646e-07 -0.09811386354225676 -1.5319 0.7037660318500891 0.7037652506203255 1.5736540799268783e-07 -0.09811443111333444 -1.532 0.7037670418508037 0.7037662562107052 1.6253944129171471e-07 -0.09811499851524523 -1.5321000000000002 0.7037680516044329 0.7037672614445263 1.6766501160711544e-07 -0.0981155657480386 -1.5322 0.7037690611105338 0.7037682663224101 1.7274096117750326e-07 -0.09811613281176401 -1.5323000000000002 0.7037700703686516 0.7037692708449903 1.7776614397169155e-07 -0.09811669970647088 -1.5324 0.7037710793783181 0.7037702750129121 1.8273942585175784e-07 -0.09811726643220856 -1.5325 0.7037720881390541 0.703771278826833 1.8765968485753848e-07 -0.09811783298902645 -1.5326000000000002 0.7037730966503684 0.7037722822874224 1.925258114945927e-07 -0.0981183993769739 -1.5327 0.7037741049117578 0.7037732853953611 1.9733670894583888e-07 -0.09811896559610034 -1.5328000000000002 0.7037751129227079 0.7037742881513418 2.0209129334911036e-07 -0.09811953164645507 -1.5329000000000002 0.7037761206826924 0.7037752905560686 2.0678849398797494e-07 -0.09812009752808745 -1.533 0.7037771281911738 0.7037762926102562 2.1142725361092407e-07 -0.09812066324104673 -1.5331000000000001 0.7037781354476037 0.7037772943146314 2.1600652859096736e-07 -0.09812122878538232 -1.5332000000000001 0.7037791424514221 0.7037782956699312 2.2052528921012726e-07 -0.09812179416114337 -1.5333 0.7037801492020591 0.7037792966769036 2.249825198849531e-07 -0.09812235936837928 -1.5334 0.7037811556989332 0.7037802973363076 2.2937721939897404e-07 -0.09812292440713927 -1.5335 0.7037821619414527 0.7037812976489126 2.337084010831103e-07 -0.09812348927747261 -1.5336 0.7037831679290153 0.7037822976154979 2.379750930966984e-07 -0.09812405397942847 -1.5337 0.7037841736610086 0.7037832972368535 2.4217633859402454e-07 -0.09812461851305615 -1.5338000000000003 0.7037851791368105 0.7037842965137793 2.463111959741249e-07 -0.09812518287840483 -1.5339 0.7037861843557882 0.7037852954470847 2.5037873907507446e-07 -0.09812574707552368 -1.534 0.7037871893173 0.7037862940375892 2.543780574168486e-07 -0.09812631110446192 -1.5341000000000002 0.703788194020694 0.7037872922861217 2.583082563470396e-07 -0.09812687496526872 -1.5342 0.7037891984653092 0.7037882901935205 2.621684572629013e-07 -0.09812743865799319 -1.5343000000000002 0.7037902026504752 0.703789287760633 2.659577978542105e-07 -0.09812800218268451 -1.5344 0.7037912065755129 0.7037902849883154 2.6967543222122803e-07 -0.09812856553939175 -1.5345 0.7037922102397338 0.7037912818774331 2.733205310898046e-07 -0.09812912872816408 -1.5346000000000002 0.7037932136424409 0.7037922784288603 2.768922820403641e-07 -0.09812969174905056 -1.5347 0.703794216782929 0.7037932746434789 2.803898896189261e-07 -0.09813025460210033 -1.5348000000000002 0.7037952196604842 0.7037942705221796 2.838125755660892e-07 -0.09813081728736239 -1.5349000000000002 0.7037962222743845 0.7037952660658613 2.871595789766257e-07 -0.09813137980488579 -1.535 0.7037972246239006 0.7037962612754302 2.904301564451983e-07 -0.09813194215471963 -1.5351000000000001 0.7037982267082943 0.7037972561518007 2.936235822814659e-07 -0.09813250433691288 -1.5352000000000001 0.7037992285268208 0.7037982506958951 2.9673914859335015e-07 -0.09813306635151464 -1.5353 0.7038002300787273 0.7037992449086422 2.9977616554377473e-07 -0.09813362819857384 -1.5354 0.7038012313632542 0.7038002387909784 3.0273396140617637e-07 -0.0981341898781395 -1.5355 0.7038022323796346 0.7038012323438466 3.05611882751855e-07 -0.09813475139026052 -1.5356 0.7038032331270951 0.703802225568197 3.0840929463038513e-07 -0.09813531273498596 -1.5357 0.7038042336048558 0.7038032184649865 3.11125580673699e-07 -0.09813587391236472 -1.5358000000000003 0.7038052338121301 0.7038042110351773 3.1376014324874246e-07 -0.09813643492244577 -1.5359 0.703806233748125 0.7038052032797388 3.163124035754361e-07 -0.09813699576527797 -1.536 0.7038072334120422 0.703806195199646 3.187818018030031e-07 -0.09813755644091028 -1.5361000000000002 0.7038082328030769 0.7038071867958794 3.211677972320137e-07 -0.09813811694939155 -1.5362 0.7038092319204193 0.7038081780694253 3.234698683560189e-07 -0.09813867729077069 -1.5363000000000002 0.7038102307632539 0.7038091690212749 3.256875130211445e-07 -0.09813923746509652 -1.5364 0.7038112293307601 0.7038101596524251 3.278202485093584e-07 -0.09813979747241794 -1.5365 0.7038122276221125 0.7038111499638775 3.29867611684187e-07 -0.09814035731278375 -1.5366000000000002 0.7038132256364806 0.7038121399566379 3.3182915903928745e-07 -0.09814091698624276 -1.5367 0.7038142233730299 0.7038131296317175 3.337044668094702e-07 -0.09814147649284385 -1.5368000000000002 0.703815220830921 0.7038141189901308 3.354931310747822e-07 -0.09814203583263571 -1.5369000000000002 0.7038162180093108 0.7038151080328974 3.371947677813236e-07 -0.09814259500566724 -1.537 0.7038172149073523 0.7038160967610395 3.388090129563537e-07 -0.0981431540119871 -1.5371000000000001 0.7038182115241944 0.7038170851755841 3.403355226805349e-07 -0.09814371285164411 -1.5372000000000001 0.7038192078589831 0.7038180732775607 3.417739732475278e-07 -0.09814427152468698 -1.5373 0.703820203910861 0.7038190610680028 3.431240610737851e-07 -0.09814483003116449 -1.5374 0.7038211996789674 0.7038200485479467 3.4438550295529113e-07 -0.09814538837112531 -1.5375 0.703822195162439 0.7038210357184304 3.4555803592878354e-07 -0.09814594654461815 -1.5376 0.7038231903604096 0.7038220225804956 3.466414175562482e-07 -0.09814650455169166 -1.5377 0.7038241852720113 0.7038230091351863 3.4763542581389695e-07 -0.09814706239239454 -1.5378000000000003 0.7038251798963733 0.7038239953835481 3.485398591268618e-07 -0.09814762006677544 -1.5379 0.7038261742326234 0.7038249813266286 3.493545364871564e-07 -0.09814817757488299 -1.538 0.7038271682798876 0.7038259669654774 3.5007929746061484e-07 -0.09814873491676589 -1.5381000000000002 0.7038281620372899 0.7038269523011451 3.507140022354638e-07 -0.0981492920924727 -1.5382 0.703829155503954 0.7038279373346836 3.512585316153838e-07 -0.09814984910205203 -1.5383000000000002 0.7038301486790016 0.7038289220671461 3.5171278702644804e-07 -0.09815040594555247 -1.5384 0.7038311415615539 0.7038299064995863 3.5207669060732805e-07 -0.09815096262302257 -1.5385 0.7038321341507319 0.7038308906330587 3.523501851329658e-07 -0.09815151913451098 -1.5386000000000002 0.7038331264456554 0.7038318744686178 3.525332341325349e-07 -0.09815207548006613 -1.5387 0.7038341184454449 0.7038328580073185 3.526258217437239e-07 -0.09815263165973667 -1.5388000000000002 0.7038351101492202 0.7038338412502158 3.526279528237586e-07 -0.09815318767357105 -1.5389000000000002 0.7038361015561018 0.7038348241983636 3.5253965293552403e-07 -0.09815374352161779 -1.539 0.7038370926652107 0.7038358068528161 3.5236096829205366e-07 -0.09815429920392543 -1.5391000000000001 0.7038380834756683 0.7038367892146264 3.5209196573571244e-07 -0.09815485472054242 -1.5392000000000001 0.7038390739865976 0.7038377712848464 3.51732732800647e-07 -0.09815541007151724 -1.5393000000000001 0.7038400641971216 0.7038387530645268 3.512833775878854e-07 -0.09815596525689826 -1.5394 0.703841054106366 0.7038397345547175 3.507440287445207e-07 -0.09815652027673405 -1.5395 0.7038420437134574 0.7038407157564659 3.5011483549840516e-07 -0.09815707513107294 -1.5396 0.7038430330175239 0.7038416966708182 3.493959675610059e-07 -0.09815762981996337 -1.5397 0.7038440220176965 0.703842677298818 3.48587615113527e-07 -0.09815818434345375 -1.5398000000000003 0.7038450107131077 0.7038436576415072 3.476899887097651e-07 -0.09815873870159246 -1.5399 0.7038459991028929 0.7038446376999248 3.467033193038649e-07 -0.09815929289442789 -1.54 0.7038469871861901 0.7038456174751067 3.456278581115413e-07 -0.09815984692200834 -1.5401000000000002 0.70384797496214 0.7038465969680865 3.44463876568446e-07 -0.09816040078438226 -1.5402 0.7038489624298867 0.7038475761798946 3.4321166632322875e-07 -0.0981609544815979 -1.5403000000000002 0.7038499495885776 0.7038485551115573 3.418715390363092e-07 -0.0981615080137036 -1.5404 0.7038509364373634 0.703849533764098 3.4044382646314375e-07 -0.09816206138074766 -1.5405 0.7038519229753988 0.7038505121385362 3.389288802599366e-07 -0.0981626145827784 -1.5406000000000002 0.7038529092018422 0.7038514902358872 3.3732707187261735e-07 -0.09816316761984406 -1.5407 0.7038538951158564 0.703852468057162 3.356387925784743e-07 -0.09816372049199287 -1.5408000000000002 0.7038548807166088 0.7038534456033674 3.338644533126822e-07 -0.09816427319927318 -1.5409000000000002 0.703855866003271 0.7038544228755053 3.3200448452952447e-07 -0.09816482574173312 -1.541 0.7038568509750196 0.7038553998745728 3.3005933615382066e-07 -0.09816537811942097 -1.5411000000000001 0.7038578356310363 0.7038563766015623 3.280294774490877e-07 -0.09816593033238497 -1.5412000000000001 0.7038588199705076 0.7038573530574603 3.259153969412121e-07 -0.09816648238067321 -1.5413000000000001 0.7038598039926263 0.7038583292432484 3.2371760226579394e-07 -0.098167034264334 -1.5414 0.7038607876965897 0.7038593051599021 3.2143662004324725e-07 -0.09816758598341543 -1.5415 0.703861771081602 0.7038602808083912 3.1907299578859405e-07 -0.09816813753796569 -1.5416 0.7038627541468728 0.7038612561896794 3.166272937032977e-07 -0.09816868892803292 -1.5417 0.703863736891618 0.703862231304724 3.1410009666138494e-07 -0.09816924015366518 -1.5418000000000003 0.7038647193150602 0.7038632061544762 3.1149200598046267e-07 -0.0981697912149107 -1.5419 0.7038657014164281 0.70386418073988 3.08803641269062e-07 -0.09817034211181748 -1.542 0.7038666831949578 0.7038651550618726 3.060356403711273e-07 -0.09817089284443364 -1.5421 0.7038676646498923 0.7038661291213848 3.0318865911621584e-07 -0.09817144341280726 -1.5422 0.7038686457804815 0.7038671029193393 3.0026337123623126e-07 -0.09817199381698642 -1.5423000000000002 0.703869626585983 0.7038680764566522 2.972604681503177e-07 -0.0981725440570192 -1.5424 0.7038706070656616 0.703869049734231 2.94180658826082e-07 -0.09817309413295354 -1.5425 0.7038715872187902 0.703870022752976 2.9102466966857143e-07 -0.09817364404483749 -1.5426000000000002 0.7038725670446496 0.7038709955137796 2.877932442149622e-07 -0.09817419379271909 -1.5427 0.7038735465425288 0.7038719680175255 2.84487143113743e-07 -0.09817474337664629 -1.5428000000000002 0.7038745257117247 0.7038729402650896 2.811071438124646e-07 -0.09817529279666709 -1.5429000000000002 0.7038755045515435 0.703873912257339 2.776540404744732e-07 -0.0981758420528295 -1.543 0.703876483061299 0.7038748839951319 2.7412864372911017e-07 -0.09817639114518141 -1.5431000000000001 0.7038774612403149 0.7038758554793179 2.705317805121177e-07 -0.0981769400737708 -1.5432000000000001 0.7038784390879231 0.7038768267107374 2.6686429386441057e-07 -0.09817748883864555 -1.5433000000000001 0.703879416603465 0.7038777976902216 2.631270427586041e-07 -0.0981780374398536 -1.5434 0.7038803937862914 0.7038787684185925 2.593209018075804e-07 -0.09817858587744287 -1.5435 0.7038813706357627 0.7038797388966622 2.554467612575495e-07 -0.09817913415146123 -1.5436 0.7038823471512484 0.703880709125233 2.5150552650232694e-07 -0.09817968226195649 -1.5437 0.7038833233321288 0.7038816791050977 2.4749811810415023e-07 -0.09818023020897657 -1.5438000000000003 0.7038842991777933 0.7038826488370389 2.434254714744899e-07 -0.09818077799256929 -1.5439 0.7038852746876423 0.7038836183218292 2.3928853666588257e-07 -0.09818132561278259 -1.544 0.7038862498610854 0.7038845875602303 2.350882781845809e-07 -0.09818187306966411 -1.5441 0.7038872246975436 0.7038855565529938 2.3082567475463112e-07 -0.09818242036326176 -1.5442 0.7038881991964485 0.7038865253008606 2.26501718998684e-07 -0.09818296749362337 -1.5443000000000002 0.7038891733572417 0.7038874938045607 2.2211741734778911e-07 -0.0981835144607966 -1.5444 0.7038901471793763 0.7038884620648134 2.1767378976383922e-07 -0.09818406126482931 -1.5445 0.7038911206623164 0.7038894300823262 2.131718694342588e-07 -0.0981846079057692 -1.5446000000000002 0.7038920938055371 0.7038903978577963 2.0861270261587905e-07 -0.098185154383664 -1.5447 0.703893066608525 0.703891365391909 2.039973483330959e-07 -0.0981857006985615 -1.5448000000000002 0.7038940390707779 0.7038923326853381 1.9932687818011163e-07 -0.09818624685050935 -1.5449000000000002 0.7038950111918054 0.7038932997387461 1.9460237602950126e-07 -0.09818679283955528 -1.545 0.7038959829711287 0.7038942665527832 1.8982493780322907e-07 -0.0981873386657469 -1.5451000000000001 0.7038969544082809 0.7038952331280883 1.8499567123672622e-07 -0.09818788432913196 -1.5452000000000001 0.7038979255028073 0.7038961994652877 1.8011569557010998e-07 -0.0981884298297581 -1.5453000000000001 0.7038988962542646 0.7038971655649962 1.7518614134695576e-07 -0.09818897516767292 -1.5454 0.7038998666622225 0.703898131427816 1.7020815010898582e-07 -0.09818952034292414 -1.5455 0.7039008367262624 0.7038990970543368 1.6518287415320798e-07 -0.0981900653555593 -1.5456 0.7039018064459784 0.7039000624451363 1.601114762578293e-07 -0.09819061020562603 -1.5457 0.7039027758209775 0.7039010276007789 1.5499512943245586e-07 -0.09819115489317194 -1.5458000000000003 0.7039037448508783 0.703901992521817 1.4983501661625098e-07 -0.09819169941824457 -1.5459 0.7039047135353133 0.7039029572087898 1.446323304107877e-07 -0.09819224378089152 -1.546 0.7039056818739269 0.703903921662224 1.3938827282677924e-07 -0.09819278798116028 -1.5461 0.703906649866377 0.7039048858826328 1.3410405500305367e-07 -0.09819333201909843 -1.5462 0.7039076175123345 0.7039058498705166 1.287808968838955e-07 -0.0981938758947535 -1.5463000000000002 0.7039085848114832 0.7039068136263626 1.234200269865926e-07 -0.09819441960817295 -1.5464 0.7039095517635204 0.703907777150645 1.1802268211694167e-07 -0.09819496315940435 -1.5465 0.7039105183681564 0.7039087404438241 1.125901070569979e-07 -0.09819550654849513 -1.5466000000000002 0.7039114846251151 0.7039097035063472 1.071235542805804e-07 -0.0981960497754928 -1.5467 0.7039124505341336 0.7039106663386477 1.0162428369306364e-07 -0.09819659284044474 -1.5468000000000002 0.7039134160949627 0.7039116289411461 9.609356230178001e-08 -0.09819713574339846 -1.5469000000000002 0.7039143813073672 0.7039125913142485 9.053266396621962e-08 -0.09819767848440139 -1.547 0.7039153461711245 0.7039135534583476 8.494286906149395e-08 -0.09819822106350089 -1.5471000000000001 0.7039163106860271 0.7039145153738227 7.932546422333153e-08 -0.09819876348074445 -1.5472000000000001 0.7039172748518805 0.7039154770610383 7.368174202194988e-08 -0.09819930573617942 -1.5473000000000001 0.7039182386685039 0.7039164385203455 6.801300069143867e-08 -0.0981998478298531 -1.5474 0.703919202135731 0.7039173997520818 6.232054380016228e-08 -0.09820038976181296 -1.5475 0.7039201652534093 0.7039183607565702 5.660567998361232e-08 -0.09820093153210631 -1.5476 0.7039211280213999 0.7039193215341197 5.086972261134082e-08 -0.09820147314078048 -1.5477 0.7039220904395787 0.7039202820850253 4.5113989511139096e-08 -0.09820201458788283 -1.5478000000000003 0.7039230525078348 0.7039212424095675 3.933980265852233e-08 -0.09820255587346058 -1.5479 0.7039240142260723 0.7039222025080132 3.3548487866214005e-08 -0.09820309699756108 -1.548 0.7039249755942094 0.7039231623806146 2.7741374489242965e-08 -0.09820363796023167 -1.5481 0.7039259366121782 0.7039241220276097 2.1919795112693152e-08 -0.09820417876151953 -1.5482 0.703926897279925 0.703925081449222 1.6085085255065912e-08 -0.09820471940147196 -1.5483000000000002 0.7039278575974106 0.7039260406456609 1.0238583049958228e-08 -0.09820525988013618 -1.5484 0.7039288175646102 0.7039269996171216 4.381628945955562e-09 -0.09820580019755941 -1.5485 0.7039297771815133 0.7039279583637845 -1.4844345934753034e-09 -0.09820634035378892 -1.5486000000000002 0.7039307364481234 0.703928916885816 -7.358263409175392e-09 -0.09820688034887184 -1.5487 0.7039316953644591 0.7039298751833678 -1.3238511954206944e-08 -0.09820742018285546 -1.5488000000000002 0.7039326539305524 0.7039308332565772 -1.9123833594827944e-08 -0.09820795985578684 -1.5489000000000002 0.7039336121464506 0.7039317911055675 -2.5012880918839214e-08 -0.09820849936771324 -1.549 0.7039345700122148 0.7039327487304468 -3.0904306051954614e-08 -0.09820903871868175 -1.5491000000000001 0.7039355275279211 0.7039337061313093 -3.679676095595663e-08 -0.09820957790873958 -1.5492000000000001 0.703936484693659 0.7039346633082345 -4.2688897746476044e-08 -0.09821011693793374 -1.5493000000000001 0.7039374415095332 0.7039356202612878 -4.8579368996189056e-08 -0.09821065580631143 -1.5494 0.7039383979756627 0.7039365769905197 -5.44668280421344e-08 -0.09821119451391971 -1.5495 0.7039393540921807 0.7039375334959665 -6.034992929481939e-08 -0.09821173306080566 -1.5496 0.7039403098592343 0.7039384897776504 -6.622732854786803e-08 -0.09821227144701636 -1.5497 0.7039412652769861 0.703939445835579 -7.209768328316976e-08 -0.0982128096725989 -1.5498000000000003 0.703942220345612 0.703940401669745 -7.795965297277552e-08 -0.09821334773760027 -1.5499 0.7039431750653025 0.7039413572801277 -8.381189939375006e-08 -0.09821388564206752 -1.55 0.7039441294362623 0.7039423126666917 -8.965308692827911e-08 -0.09821442338604769 -1.5501 0.7039450834587104 0.7039432678293869 -9.548188287071546e-08 -0.09821496096958776 -1.5502 0.7039460371328803 0.7039442227681496 -1.0129695772811975e-07 -0.09821549839273473 -1.5503000000000002 0.7039469904590191 0.7039451774829015 -1.0709698552904129e-07 -0.0982160356555356 -1.5504 0.703947943437388 0.7039461319735505 -1.1288064411495158e-07 -0.0982165727580373 -1.5505 0.7039488960682625 0.7039470862399901 -1.1864661545769872e-07 -0.09821710970028674 -1.5506000000000002 0.7039498483519323 0.7039480402820997 -1.2439358594920624e-07 -0.09821764648233093 -1.5507 0.7039508002887007 0.7039489940997445 -1.3012024669724342e-07 -0.09821818310421672 -1.5508000000000002 0.7039517518788856 0.7039499476927766 -1.3582529383160402e-07 -0.09821871956599111 -1.5509000000000002 0.7039527031228178 0.7039509010610334 -1.4150742880247869e-07 -0.09821925586770097 -1.551 0.7039536540208424 0.7039518542043384 -1.4716535866494962e-07 -0.09821979200939313 -1.5511000000000001 0.7039546045733185 0.7039528071225019 -1.5279779637909774e-07 -0.09822032799111455 -1.5512000000000001 0.7039555547806182 0.7039537598153199 -1.5840346111010983e-07 -0.09822086381291201 -1.5513000000000001 0.7039565046431278 0.7039547122825752 -1.6398107851450794e-07 -0.09822139947483238 -1.5514000000000001 0.7039574541612466 0.7039556645240368 -1.6952938101597037e-07 -0.0982219349769225 -1.5515 0.7039584033353881 0.7039566165394604 -1.7504710810023472e-07 -0.09822247031922925 -1.5516 0.7039593521659782 0.7039575683285879 -1.805330066377564e-07 -0.09822300550179934 -1.5517 0.7039603006534567 0.7039585198911484 -1.8598583111789635e-07 -0.0982235405246796 -1.5518000000000003 0.7039612487982769 0.7039594712268572 -1.9140434393341565e-07 -0.09822407538791683 -1.5519 0.7039621966009046 0.7039604223354168 -1.9678731569966468e-07 -0.0982246100915578 -1.552 0.7039631440618184 0.7039613732165162 -2.0213352551132213e-07 -0.09822514463564919 -1.5521 0.7039640911815108 0.7039623238698322 -2.0744176122342028e-07 -0.09822567902023782 -1.5522 0.7039650379604862 0.7039632742950279 -2.1271081970808403e-07 -0.09822621324537037 -1.5523000000000002 0.7039659843992623 0.7039642244917541 -2.1793950714943389e-07 -0.09822674731109354 -1.5524 0.7039669304983691 0.7039651744596489 -2.2312663932114174e-07 -0.09822728121745408 -1.5525 0.7039678762583494 0.7039661241983375 -2.2827104180847546e-07 -0.09822781496449862 -1.5526000000000002 0.7039688216797582 0.7039670737074333 -2.333715503413658e-07 -0.09822834855227391 -1.5527 0.703969766763163 0.7039680229865365 -2.3842701098869545e-07 -0.09822888198082655 -1.5528000000000002 0.7039707115091433 0.7039689720352356 -2.4343628047401866e-07 -0.09822941525020319 -1.5529000000000002 0.7039716559182907 0.7039699208531067 -2.483982264045448e-07 -0.09822994836045049 -1.553 0.703972599991209 0.7039708694397144 -2.5331172755910236e-07 -0.0982304813116151 -1.5531000000000001 0.7039735437285137 0.7039718177946108 -2.5817567406161146e-07 -0.09823101410374357 -1.5532000000000001 0.7039744871308315 0.7039727659173365 -2.6298896776272285e-07 -0.0982315467368825 -1.5533000000000001 0.7039754301988017 0.7039737138074205 -2.677505223439014e-07 -0.09823207921107852 -1.5534000000000001 0.703976372933074 0.7039746614643805 -2.724592636782486e-07 -0.09823261152637816 -1.5535 0.7039773153343102 0.7039756088877225 -2.7711412999356644e-07 -0.098233143682828 -1.5536 0.7039782574031827 0.7039765560769412 -2.817140721707301e-07 -0.09823367568047453 -1.5537 0.7039791991403754 0.7039775030315205 -2.8625805393797665e-07 -0.09823420751936432 -1.5538000000000003 0.7039801405465829 0.7039784497509335 -2.907450521311139e-07 -0.0982347391995439 -1.5539 0.7039810816225104 0.7039793962346421 -2.9517405689474807e-07 -0.09823527072105975 -1.554 0.7039820223688742 0.7039803424820977 -2.9954407194943133e-07 -0.09823580208395842 -1.5541 0.7039829627864005 0.7039812884927412 -3.038541147790119e-07 -0.09823633328828629 -1.5542 0.7039839028758261 0.7039822342660028 -3.0810321686308706e-07 -0.09823686433408986 -1.5543000000000002 0.7039848426378983 0.7039831798013032 -3.1229042390251704e-07 -0.09823739522141561 -1.5544 0.7039857820733735 0.7039841250980524 -3.164147960310615e-07 -0.09823792595030999 -1.5545 0.7039867211830186 0.7039850701556507 -3.2047540802354613e-07 -0.09823845652081929 -1.5546000000000002 0.7039876599676105 0.7039860149734889 -3.244713494970908e-07 -0.09823898693299012 -1.5547 0.7039885984279348 0.7039869595509478 -3.284017251400928e-07 -0.09823951718686874 -1.5548000000000002 0.7039895365647871 0.7039879038873992 -3.322656548787606e-07 -0.09824004728250159 -1.5549000000000002 0.7039904743789721 0.7039888479822052 -3.3606227408528033e-07 -0.09824057721993501 -1.555 0.7039914118713031 0.7039897918347191 -3.397907337651662e-07 -0.0982411069992154 -1.5551000000000001 0.7039923490426027 0.7039907354442856 -3.4345020080706057e-07 -0.09824163662038907 -1.5552000000000001 0.7039932858937024 0.7039916788102398 -3.4703985807293947e-07 -0.09824216608350236 -1.5553000000000001 0.7039942224254414 0.703992621931909 -3.5055890466872963e-07 -0.09824269538860161 -1.5554000000000001 0.7039951586386684 0.7039935648086117 -3.5400655601369735e-07 -0.0982432245357331 -1.5555 0.7039960945342391 0.7039945074396585 -3.5738204411800423e-07 -0.09824375352494316 -1.5556 0.703997030113018 0.7039954498243519 -3.6068461774230176e-07 -0.09824428235627805 -1.5557 0.703997965375877 0.7039963919619863 -3.639135425226314e-07 -0.09824481102978405 -1.5558 0.7039989003236958 0.7039973338518483 -3.6706810115777477e-07 -0.09824533954550742 -1.5559 0.7039998349573615 0.7039982754932174 -3.701475935272147e-07 -0.09824586790349435 -1.556 0.7040007692777683 0.7039992168853656 -3.731513369478745e-07 -0.0982463961037911 -1.5561 0.704001703285818 0.7040001580275581 -3.7607866618799557e-07 -0.09824692414644388 -1.5562 0.7040026369824186 0.7040010989190526 -3.789289337446933e-07 -0.09824745203149894 -1.5563000000000002 0.7040035703684853 0.7040020395591007 -3.8170150988559026e-07 -0.09824797975900243 -1.5564 0.7040045034449394 0.7040029799469467 -3.843957828361666e-07 -0.09824850732900049 -1.5565 0.7040054362127086 0.7040039200818293 -3.8701115894629323e-07 -0.09824903474153932 -1.5566000000000002 0.7040063686727269 0.7040048599629808 -3.8954706275268203e-07 -0.09824956199666507 -1.5567 0.7040073008259342 0.7040057995896274 -3.9200293711072476e-07 -0.0982500890944239 -1.5568000000000002 0.7040082326732762 0.7040067389609894 -3.943782434026599e-07 -0.0982506160348619 -1.5569000000000002 0.7040091642157036 0.7040076780762818 -3.9667246153063385e-07 -0.09825114281802522 -1.557 0.7040100954541728 0.7040086169347144 -3.9888509015956197e-07 -0.09825166944395992 -1.5571000000000002 0.7040110263896454 0.7040095555354915 -4.0101564670325107e-07 -0.09825219591271211 -1.5572000000000001 0.7040119570230878 0.7040104938778127 -4.0306366752562717e-07 -0.09825272222432785 -1.5573000000000001 0.704012887355471 0.7040114319608725 -4.050287079962467e-07 -0.09825324837885324 -1.5574000000000001 0.7040138173877705 0.7040123697838611 -4.069103425666243e-07 -0.09825377437633426 -1.5575 0.7040147471209661 0.7040133073459642 -4.0870816491594963e-07 -0.09825430021681694 -1.5576 0.7040156765560419 0.7040142446463638 -4.1042178801353746e-07 -0.09825482590034733 -1.5577 0.7040166056939858 0.7040151816842375 -4.1205084420903315e-07 -0.09825535142697145 -1.5578 0.7040175345357892 0.7040161184587591 -4.1359498528098504e-07 -0.09825587679673525 -1.5579 0.7040184630824471 0.7040170549690994 -4.150538825478667e-07 -0.09825640200968477 -1.558 0.7040193913349581 0.7040179912144255 -4.1642722688889355e-07 -0.09825692706586595 -1.5581 0.7040203192943233 0.7040189271939017 -4.1771472887586203e-07 -0.09825745196532482 -1.5582 0.7040212469615468 0.7040198629066889 -4.1891611880090496e-07 -0.0982579767081072 -1.5583000000000002 0.7040221743376353 0.7040207983519458 -4.200311467320028e-07 -0.09825850129425907 -1.5584 0.7040231014235978 0.7040217335288285 -4.2105958255461706e-07 -0.09825902572382635 -1.5585 0.704024028220446 0.704022668436491 -4.220012160202624e-07 -0.09825954999685495 -1.5586000000000002 0.7040249547291931 0.704023603074085 -4.228558567812013e-07 -0.09826007411339077 -1.5587 0.7040258809508542 0.7040245374407603 -4.2362333451534395e-07 -0.09826059807347963 -1.5588000000000002 0.7040268068864461 0.7040254715356655 -4.243034988360428e-07 -0.09826112187716747 -1.5589000000000002 0.7040277325369868 0.7040264053579477 -4.2489621938923694e-07 -0.09826164552450009 -1.559 0.7040286579034953 0.7040273389067524 -4.2540138583957443e-07 -0.09826216901552336 -1.5591000000000002 0.7040295829869918 0.7040282721812248 -4.2581890794674004e-07 -0.09826269235028307 -1.5592000000000001 0.7040305077884972 0.7040292051805086 -4.2614871550994415e-07 -0.09826321552882505 -1.5593000000000001 0.7040314323090329 0.7040301379037478 -4.2639075844425056e-07 -0.09826373855119515 -1.5594000000000001 0.7040323565496198 0.7040310703500854 -4.2654500673200424e-07 -0.09826426141743909 -1.5595 0.70403328051128 0.7040320025186647 -4.266114504783425e-07 -0.09826478412760266 -1.5596 0.7040342041950348 0.704032934408629 -4.2659009984874485e-07 -0.09826530668173167 -1.5597 0.7040351276019052 0.7040338660191218 -4.2648098512454435e-07 -0.09826582907987179 -1.5598 0.7040360507329118 0.7040347973492873 -4.262841566127218e-07 -0.09826635132206885 -1.5599 0.7040369735890741 0.7040357283982702 -4.2599968468060023e-07 -0.09826687340836845 -1.56 0.7040378961714109 0.7040366591652165 -4.2562765976972283e-07 -0.09826739533881639 -1.5601 0.7040388184809396 0.7040375896492732 -4.251681922778916e-07 -0.09826791711345836 -1.5602 0.7040397405186762 0.7040385198495889 -4.246214125938619e-07 -0.09826843873234004 -1.5603000000000002 0.7040406622856349 0.7040394497653135 -4.239874710695868e-07 -0.09826896019550709 -1.5604 0.7040415837828282 0.7040403793955989 -4.232665378883782e-07 -0.09826948150300517 -1.5605 0.7040425050112664 0.7040413087395989 -4.2245880313429574e-07 -0.09827000265487991 -1.5606000000000002 0.7040434259719575 0.70404223779647 -4.2156447671581887e-07 -0.09827052365117697 -1.5607 0.7040443466659072 0.7040431665653706 -4.205837882270691e-07 -0.09827104449194195 -1.5608000000000002 0.7040452670941183 0.7040440950454618 -4.195169869894433e-07 -0.09827156517722045 -1.5609000000000002 0.7040461872575907 0.704045023235908 -4.1836434193365246e-07 -0.09827208570705806 -1.561 0.7040471071573216 0.7040459511358764 -4.1712614160666073e-07 -0.09827260608150043 -1.5611000000000002 0.7040480267943037 0.7040468787445376 -4.158026940051518e-07 -0.09827312630059305 -1.5612000000000001 0.7040489461695274 0.7040478060610655 -4.1439432652001784e-07 -0.0982736463643815 -1.5613000000000001 0.7040498652839785 0.7040487330846379 -4.1290138590166503e-07 -0.0982741662729113 -1.5614000000000001 0.7040507841386395 0.7040496598144366 -4.11324238162869e-07 -0.09827468602622805 -1.5615 0.7040517027344881 0.7040505862496476 -4.096632684677526e-07 -0.0982752056243772 -1.5616 0.704052621072498 0.7040515123894604 -4.0791888100688567e-07 -0.09827572506740423 -1.5617 0.7040535391536387 0.7040524382330702 -4.0609149899728525e-07 -0.09827624435535473 -1.5618 0.7040544569788736 0.7040533637796761 -4.0418156448118747e-07 -0.09827676348827408 -1.5619 0.7040553745491624 0.7040542890284827 -4.0218953831910875e-07 -0.09827728246620779 -1.562 0.7040562918654596 0.7040552139786991 -4.0011589996780117e-07 -0.09827780128920131 -1.5621 0.7040572089287135 0.7040561386295405 -3.9796114737616906e-07 -0.09827831995730012 -1.5622 0.7040581257398674 0.7040570629802269 -3.957257969991468e-07 -0.09827883847054958 -1.5623000000000002 0.7040590422998585 0.7040579870299843 -3.934103835478986e-07 -0.09827935682899511 -1.5624 0.7040599586096187 0.7040589107780448 -3.9101545987879627e-07 -0.09827987503268217 -1.5625 0.7040608746700728 0.7040598342236463 -3.8854159688933576e-07 -0.09828039308165608 -1.5626000000000002 0.70406179048214 0.7040607573660334 -3.8598938341405375e-07 -0.09828091097596225 -1.5627 0.7040627060467328 0.7040616802044564 -3.833594259955442e-07 -0.09828142871564603 -1.5628000000000002 0.7040636213647565 0.7040626027381731 -3.8065234880813037e-07 -0.09828194630075276 -1.5629000000000002 0.7040645364371103 0.704063524966448 -3.7786879346357605e-07 -0.09828246373132782 -1.563 0.7040654512646859 0.7040644468885526 -3.7500941894169637e-07 -0.09828298100741656 -1.5631000000000002 0.7040663658483672 0.704065368503765 -3.7207490134055776e-07 -0.09828349812906413 -1.5632000000000001 0.7040672801890315 0.7040662898113721 -3.690659337585167e-07 -0.09828401509631604 -1.5633000000000001 0.704068194287548 0.7040672108106667 -3.659832261415641e-07 -0.0982845319092174 -1.5634000000000001 0.7040691081447783 0.7040681315009507 -3.6282750510291395e-07 -0.09828504856781362 -1.5635 0.7040700217615758 0.7040690518815336 -3.5959951373565335e-07 -0.09828556507214986 -1.5636 0.7040709351387858 0.7040699719517325 -3.563000114878423e-07 -0.09828608142227144 -1.5637 0.7040718482772452 0.7040708917108733 -3.529297739196524e-07 -0.0982865976182235 -1.5638 0.7040727611777827 0.7040718111582904 -3.494895925645891e-07 -0.09828711366005138 -1.5639 0.7040736738412179 0.7040727302933265 -3.4598027470744697e-07 -0.09828762954780018 -1.564 0.7040745862683618 0.7040736491153337 -3.424026432524707e-07 -0.09828814528151522 -1.5641 0.7040754984600162 0.704074567623672 -3.387575364943718e-07 -0.09828866086124155 -1.5642 0.7040764104169741 0.7040754858177117 -3.3504580793097816e-07 -0.09828917628702444 -1.5643000000000002 0.7040773221400187 0.7040764036968316 -3.312683260411897e-07 -0.09828969155890899 -1.5644 0.7040782336299242 0.7040773212604203 -3.274259740698726e-07 -0.09829020667694037 -1.5645 0.7040791448874546 0.7040782385078759 -3.235196499237758e-07 -0.09829072164116372 -1.5646000000000002 0.7040800559133644 0.7040791554386062 -3.1955026583846413e-07 -0.09829123645162413 -1.5647 0.7040809667083981 0.704080072052029 -3.155187482326016e-07 -0.0982917511083667 -1.5648000000000002 0.7040818772732902 0.704080988347572 -3.114260374650901e-07 -0.09829226561143652 -1.5649000000000002 0.7040827876087651 0.7040819043246737 -3.0727308760608585e-07 -0.09829277996087876 -1.565 0.7040836977155364 0.704082819982782 -3.0306086631903817e-07 -0.09829329415673843 -1.5651000000000002 0.7040846075943072 0.7040837353213559 -2.9879035446517266e-07 -0.09829380819906056 -1.5652000000000001 0.7040855172457703 0.704084650339865 -2.944625459924688e-07 -0.09829432208789024 -1.5653000000000001 0.7040864266706071 0.7040855650377893 -2.900784476650431e-07 -0.09829483582327242 -1.5654000000000001 0.704087335869489 0.7040864794146202 -2.8563907885845174e-07 -0.09829534940525222 -1.5655 0.7040882448430754 0.7040873934698596 -2.811454712578487e-07 -0.09829586283387459 -1.5656 0.7040891535920151 0.7040883072030211 -2.76598668712269e-07 -0.09829637610918457 -1.5657 0.7040900621169449 0.7040892206136291 -2.719997269154395e-07 -0.09829688923122705 -1.5658 0.7040909704184908 0.7040901337012199 -2.6734971320455103e-07 -0.09829740220004707 -1.5659 0.704091878497267 0.7040910464653408 -2.6264970628964157e-07 -0.09829791501568956 -1.566 0.7040927863538757 0.7040919589055512 -2.5790079600032656e-07 -0.09829842767819948 -1.5661 0.704093693988908 0.7040928710214218 -2.531040830464071e-07 -0.0982989401876217 -1.5662 0.7040946014029423 0.704093782812536 -2.482606787854169e-07 -0.09829945254400124 -1.5663000000000002 0.7040955085965455 0.704094694278488 -2.433717048964945e-07 -0.0982999647473829 -1.5664 0.704096415570272 0.7040956054188852 -2.384382931999718e-07 -0.09830047679781162 -1.5665 0.7040973223246644 0.7040965162333466 -2.3346158532430716e-07 -0.0983009886953323 -1.5666000000000002 0.7040982288602524 0.7040974267215034 -2.2844273251873548e-07 -0.09830150043998978 -1.5667 0.7040991351775536 0.7040983368829996 -2.2338289532713995e-07 -0.09830201203182887 -1.5668000000000002 0.704100041277073 0.7040992467174919 -2.182832433243742e-07 -0.09830252347089448 -1.5669000000000002 0.7041009471593027 0.7041001562246488 -2.131449548803399e-07 -0.09830303475723136 -1.567 0.7041018528247226 0.7041010654041521 -2.079692168546754e-07 -0.09830354589088439 -1.5671000000000002 0.7041027582737994 0.7041019742556964 -2.0275722435042498e-07 -0.0983040568718984 -1.5672000000000001 0.7041036635069868 0.7041028827789885 -1.9751018039831925e-07 -0.09830456770031806 -1.5673000000000001 0.7041045685247258 0.704103790973749 -1.9222929572779157e-07 -0.09830507837618824 -1.5674000000000001 0.7041054733274443 0.704104698839711 -1.869157884616668e-07 -0.09830558889955375 -1.5675 0.704106377915557 0.7041056063766209 -1.8157088383166653e-07 -0.0983060992704592 -1.5676 0.704107282289465 0.704106513584238 -1.7619581390085348e-07 -0.09830660948894943 -1.5677 0.7041081864495569 0.7041074204623354 -1.7079181728607562e-07 -0.09830711955506918 -1.5678 0.7041090903962073 0.7041083270106987 -1.6536013886653267e-07 -0.09830762946886311 -1.5679 0.7041099941297777 0.7041092332291273 -1.5990202949754673e-07 -0.0983081392303759 -1.568 0.7041108976506162 0.7041101391174343 -1.544187457312718e-07 -0.09830864883965229 -1.5681 0.704111800959057 0.7041110446754456 -1.4891154949923935e-07 -0.09830915829673695 -1.5682 0.7041127040554209 0.7041119499030013 -1.433817078677624e-07 -0.09830966760167449 -1.5683000000000002 0.7041136069400153 0.7041128547999548 -1.3783049270833791e-07 -0.09831017675450962 -1.5684 0.7041145096131336 0.704113759366173 -1.322591804183565e-07 -0.09831068575528695 -1.5685 0.7041154120750559 0.7041146636015372 -1.2666905162966868e-07 -0.09831119460405115 -1.5686000000000002 0.7041163143260478 0.7041155675059411 -1.2106139091888624e-07 -0.09831170330084679 -1.5687 0.7041172163663616 0.7041164710792933 -1.1543748649513186e-07 -0.09831221184571845 -1.5688000000000002 0.7041181181962355 0.7041173743215159 -1.0979862991727929e-07 -0.09831272023871074 -1.5689000000000002 0.7041190198158944 0.7041182772325447 -1.0414611580512184e-07 -0.09831322847986829 -1.569 0.7041199212255487 0.7041191798123294 -9.8481241521918e-08 -0.09831373656923556 -1.5691000000000002 0.704120822425395 0.7041200820608334 -9.28053068898968e-08 -0.09831424450685712 -1.5692000000000002 0.7041217234156159 0.7041209839780345 -8.71196138901506e-08 -0.09831475229277757 -1.5693000000000001 0.7041226241963803 0.704121885563924 -8.142546636339537e-08 -0.09831525992704135 -1.5694000000000001 0.7041235247678428 0.7041227868185072 -7.572416971246554e-08 -0.09831576740969306 -1.5695 0.7041244251301446 0.7041236877418036 -7.001703060047215e-08 -0.09831627474077717 -1.5696 0.7041253252834117 0.7041245883338465 -6.43053566506957e-08 -0.09831678192033816 -1.5697 0.7041262252277571 0.7041254885946832 -5.8590456151683123e-08 -0.09831728894842046 -1.5698 0.7041271249632796 0.7041263885243749 -5.287363775518909e-08 -0.09831779582506861 -1.5699 0.7041280244900638 0.7041272881229969 -4.715621017541832e-08 -0.09831830255032703 -1.57 0.70412892380818 0.7041281873906383 -4.1439481891195236e-08 -0.09831880912424011 -1.5701 0.7041298229176851 0.7041290863274022 -3.572476084488102e-08 -0.09831931554685226 -1.5702 0.7041307218186216 0.704129984933406 -3.0013354145952756e-08 -0.09831982181820793 -1.5703000000000003 0.7041316205110184 0.7041308832087804 -2.4306567769595208e-08 -0.09832032793835158 -1.5704 0.7041325189948897 0.704131781153671 -1.8605706259087335e-08 -0.09832083390732754 -1.5705 0.7041334172702366 0.7041326787682363 -1.291207242992351e-08 -0.09832133972518017 -1.5706000000000002 0.7041343153370458 0.7041335760526493 -7.22696706645376e-09 -0.09832184539195388 -1.5707 0.7041352131952898 0.7041344730070966 -1.551688631751258e-09 -0.09832235090769299 -1.5708000000000002 0.7041361108449276 0.7041353696317788 4.112467033579037e-09 -0.09832285627244179 -1.5709000000000002 0.7041370082859044 0.7041362659269101 9.764207008038095e-09 -0.09832336148624464 -1.571 0.7041379055181517 0.7041371618927187 1.5402241577630593e-08 -0.09832386654914588 -1.5711000000000002 0.7041388025415868 0.7041380575294465 2.1025284540308886e-08 -0.09832437146118979 -1.5712000000000002 0.7041396993561134 0.704138952837349 2.6632053489600294e-08 -0.09832487622242064 -1.5713000000000001 0.7041405959616216 0.7041398478166951 3.22212701138469e-08 -0.0983253808328827 -1.5714000000000001 0.7041414923579877 0.7041407424677677 3.7791660479832845e-08 -0.09832588529262021 -1.5715 0.7041423885450748 0.7041416367908633 4.334195533202412e-08 -0.09832638960167746 -1.5716 0.704143284522732 0.7041425307862914 4.8870890372726405e-08 -0.09832689376009864 -1.5717 0.7041441802907953 0.7041434244543756 5.437720656739642e-08 -0.09832739776792804 -1.5718 0.7041450758490868 0.7041443177954523 5.98596504031157e-08 -0.09832790162520981 -1.5719 0.7041459711974156 0.7041452108098716 6.531697419737137e-08 -0.09832840533198814 -1.572 0.7041468663355778 0.7041461034979966 7.074793637734667e-08 -0.09832890888830731 -1.5721 0.7041477612633553 0.7041469958602038 7.615130174880302e-08 -0.09832941229421144 -1.5722 0.7041486559805179 0.7041478878968827 8.152584180312616e-08 -0.09832991554974466 -1.5723000000000003 0.7041495504868216 0.7041487796084358 8.687033495845264e-08 -0.09833041865495115 -1.5724 0.7041504447820096 0.7041496709952786 9.218356687018536e-08 -0.09833092160987504 -1.5725 0.7041513388658123 0.7041505620578394 9.746433071028404e-08 -0.09833142441456043 -1.5726000000000002 0.7041522327379472 0.7041514527965593 1.0271142740145289e-07 -0.09833192706905143 -1.5727 0.7041531263981189 0.7041523432118924 1.0792366593459501e-07 -0.09833242957339214 -1.5728000000000002 0.7041540198460197 0.7041532333043048 1.1309986360993896e-07 -0.09833293192762665 -1.5729000000000002 0.7041549130813287 0.7041541230742758 1.182388463319417e-07 -0.09833343413179904 -1.573 0.7041558061037132 0.7041550125222971 1.233394488243944e-07 -0.09833393618595337 -1.5731000000000002 0.7041566989128281 0.7041559016488721 1.284005149600198e-07 -0.09833443809013372 -1.5732000000000002 0.7041575915083151 0.704156790454517 1.3342089797210854e-07 -0.09833493984438407 -1.5733000000000001 0.7041584838898047 0.7041576789397597 1.3839946075289156e-07 -0.09833544144874842 -1.5734000000000001 0.704159376056915 0.7041585671051409 1.4333507606170692e-07 -0.09833594290327091 -1.5735 0.704160268009252 0.7041594549512122 1.4822662684765842e-07 -0.09833644420799537 -1.5736 0.7041611597464104 0.7041603424785378 1.5307300642308785e-07 -0.0983369453629659 -1.5737 0.7041620512679724 0.7041612296876931 1.5787311878623367e-07 -0.09833744636822647 -1.5738 0.704162942573509 0.7041621165792653 1.6262587883286717e-07 -0.098337947223821 -1.5739 0.7041638336625796 0.704163003153853 1.6733021259915382e-07 -0.0983384479297934 -1.574 0.7041647245347323 0.7041638894120662 1.7198505751145343e-07 -0.09833894848618768 -1.5741 0.7041656151895042 0.7041647753545259 1.765893626326509e-07 -0.09833944889304774 -1.5742 0.7041665056264206 0.7041656609818643 1.8114208888767025e-07 -0.09833994915041748 -1.5743000000000003 0.7041673958449964 0.7041665462947249 1.8564220932368314e-07 -0.09834044925834083 -1.5744 0.7041682858447356 0.7041674312937614 1.9008870928705068e-07 -0.09834094921686165 -1.5745 0.7041691756251311 0.7041683159796386 1.9448058670434865e-07 -0.09834144902602387 -1.5746000000000002 0.7041700651856653 0.7041692003530315 1.988168523009426e-07 -0.09834194868587122 -1.5747 0.7041709545258106 0.704170084414626 2.0309652980221582e-07 -0.09834244819644766 -1.5748000000000002 0.7041718436450286 0.7041709681651178 2.073186561590834e-07 -0.09834294755779703 -1.5749000000000002 0.7041727325427709 0.7041718516052131 2.114822817700368e-07 -0.09834344676996311 -1.575 0.704173621218479 0.7041727347356275 2.1558647071706627e-07 -0.09834394583298971 -1.5751000000000002 0.7041745096715848 0.704173617557087 2.1963030093913316e-07 -0.09834444474692061 -1.5752000000000002 0.7041753979015101 0.704174500070327 2.236128644333979e-07 -0.09834494351179965 -1.5753000000000001 0.7041762859076673 0.7041753822760926 2.2753326751195901e-07 -0.09834544212767055 -1.5754000000000001 0.7041771736894596 0.704176264175138 2.3139063094063106e-07 -0.09834594059457712 -1.5755 0.7041780612462806 0.7041771457682267 2.3518409017486697e-07 -0.098346438912563 -1.5756000000000001 0.704178948577515 0.7041780270561313 2.389127955679249e-07 -0.09834693708167203 -1.5757 0.7041798356825386 0.7041789080396335 2.4257591249576826e-07 -0.09834743510194793 -1.5758 0.7041807225607185 0.7041797887195236 2.461726216276827e-07 -0.09834793297343443 -1.5759 0.7041816092114128 0.7041806690966002 2.4970211902342054e-07 -0.0983484306961752 -1.576 0.7041824956339717 0.7041815491716705 2.531636163830009e-07 -0.09834892827021391 -1.5761 0.704183381827737 0.7041824289455498 2.5655634118548765e-07 -0.09834942569559425 -1.5762 0.7041842677920418 0.7041833084190616 2.598795368763396e-07 -0.09834992297235992 -1.5763000000000003 0.704185153526212 0.7041841875930375 2.6313246304088267e-07 -0.09835042010055454 -1.5764 0.7041860390295656 0.704185066468316 2.663143955222713e-07 -0.09835091708022171 -1.5765 0.7041869243014125 0.7041859450457437 2.6942462666434963e-07 -0.0983514139114051 -1.5766000000000002 0.7041878093410561 0.7041868233261748 2.7246246540185703e-07 -0.09835191059414827 -1.5767 0.7041886941477918 0.7041877013104703 2.7542723742696174e-07 -0.0983524071284949 -1.5768000000000002 0.7041895787209087 0.7041885789994979 2.7831828538354975e-07 -0.09835290351448854 -1.5769000000000002 0.7041904630596885 0.7041894563941329 2.8113496892273604e-07 -0.09835339975217278 -1.577 0.704191347163406 0.7041903334952566 2.838766649734814e-07 -0.09835389584159117 -1.5771000000000002 0.7041922310313303 0.7041912103037571 2.8654276773565357e-07 -0.09835439178278726 -1.5772 0.7041931146627235 0.704192086820528 2.8913268890901067e-07 -0.09835488757580457 -1.5773000000000001 0.7041939980568419 0.70419296304647 2.9164585781810137e-07 -0.09835538322068665 -1.5774000000000001 0.7041948812129362 0.7041938389824891 2.940817214955316e-07 -0.09835587871747697 -1.5775 0.7041957641302508 0.7041947146294969 2.964397448138034e-07 -0.09835637406621914 -1.5776000000000001 0.704196646808025 0.7041955899884111 2.987194106379709e-07 -0.09835686926695658 -1.5777 0.7041975292454922 0.7041964650601538 3.0092021989502893e-07 -0.09835736431973277 -1.5778 0.7041984114418812 0.7041973398456526 3.030416917335077e-07 -0.09835785922459112 -1.5779 0.7041992933964161 0.7041982143458403 3.0508336357204513e-07 -0.09835835398157515 -1.578 0.7042001751083153 0.7041990885616543 3.070447912520424e-07 -0.09835884859072833 -1.5781 0.7042010565767937 0.704199962494036 3.089255490792975e-07 -0.09835934305209407 -1.5782 0.7042019378010608 0.7042008361439316 3.107252299766605e-07 -0.0983598373657157 -1.5783000000000003 0.7042028187803226 0.7042017095122911 3.124434455048508e-07 -0.09836033153163667 -1.5784 0.7042036995137814 0.7042025826000688 3.140798260012345e-07 -0.09836082554990042 -1.5785 0.7042045800006351 0.7042034554082226 3.1563402064921364e-07 -0.09836131942055028 -1.5786000000000002 0.7042054602400786 0.7042043279377137 3.171056975129205e-07 -0.09836181314362971 -1.5787 0.7042063402313028 0.7042052001895065 3.1849454365517893e-07 -0.09836230671918193 -1.5788000000000002 0.7042072199734959 0.7042060721645688 3.198002651930154e-07 -0.09836280014725031 -1.5789000000000002 0.7042080994658432 0.7042069438638712 3.2102258736704803e-07 -0.09836329342787825 -1.579 0.7042089787075272 0.704207815288387 3.2216125457618094e-07 -0.098363786561109 -1.5791000000000002 0.7042098576977276 0.704208686439092 3.2321603039842106e-07 -0.09836427954698587 -1.5792 0.7042107364356225 0.7042095573169638 3.2418669771577813e-07 -0.09836477238555215 -1.5793000000000001 0.7042116149203872 0.704210427922983 3.250730587350814e-07 -0.09836526507685119 -1.5794000000000001 0.7042124931511953 0.7042112982581316 3.258749350018575e-07 -0.09836575762092623 -1.5795 0.7042133711272185 0.7042121683233926 3.265921674627803e-07 -0.09836625001782044 -1.5796000000000001 0.7042142488476275 0.7042130381197518 3.2722461644485445e-07 -0.09836674226757719 -1.5797 0.7042151263115916 0.7042139076481952 3.2777216175255974e-07 -0.09836723437023967 -1.5798 0.7042160035182785 0.70421477690971 3.2823470266091226e-07 -0.09836772632585108 -1.5799 0.7042168804668554 0.7042156459052843 3.286121579085255e-07 -0.09836821813445458 -1.58 0.7042177571564888 0.704216514635907 3.2890446578087706e-07 -0.09836870979609343 -1.5801 0.7042186335863453 0.7042173831025671 3.291115839992864e-07 -0.09836920131081084 -1.5802 0.7042195097555902 0.7042182513062542 3.292334898458149e-07 -0.09836969267864988 -1.5803000000000003 0.7042203856633895 0.7042191192479572 3.2927018010081577e-07 -0.09837018389965377 -1.5804 0.7042212613089094 0.7042199869286656 3.2922167107068967e-07 -0.09837067497386565 -1.5805 0.704222136691316 0.7042208543493681 3.290879984838013e-07 -0.09837116590132865 -1.5806000000000002 0.7042230118097763 0.7042217215110526 3.2886921763619625e-07 -0.0983716566820859 -1.5807 0.7042238866634583 0.7042225884147064 3.285654032805785e-07 -0.09837214731618052 -1.5808000000000002 0.7042247612515307 0.7042234550613156 3.281766495430438e-07 -0.0983726378036556 -1.5809000000000002 0.7042256355731634 0.7042243214518648 3.2770307002022436e-07 -0.09837312814455418 -1.581 0.7042265096275281 0.7042251875873378 3.271447976890829e-07 -0.09837361833891939 -1.5811000000000002 0.7042273834137976 0.704226053468716 3.265019848583406e-07 -0.09837410838679428 -1.5812 0.7042282569311468 0.7042269190969794 3.2577480317541596e-07 -0.09837459828822183 -1.5813000000000001 0.7042291301787529 0.704227784473106 3.2496344349458584e-07 -0.09837508804324514 -1.5814000000000001 0.7042300031557949 0.704228649598071 3.240681159394354e-07 -0.09837557765190727 -1.5815 0.7042308758614546 0.7042295144728472 3.230890497432637e-07 -0.09837606711425116 -1.5816000000000001 0.7042317482949163 0.704230379098405 3.2202649329071686e-07 -0.09837655643031983 -1.5817 0.704232620455367 0.7042312434757119 3.2088071395125484e-07 -0.09837704560015624 -1.5818 0.7042334923419973 0.7042321076057318 3.1965199808609013e-07 -0.09837753462380344 -1.5819 0.7042343639540007 0.7042329714894261 3.183406509996156e-07 -0.09837802350130437 -1.582 0.704235235290574 0.7042338351277516 3.169469967728711e-07 -0.09837851223270193 -1.5821 0.7042361063509179 0.7042346985216625 3.154713782704821e-07 -0.09837900081803912 -1.5822 0.7042369771342369 0.7042355616721083 3.139141569949433e-07 -0.09837948925735877 -1.5823000000000003 0.7042378476397398 0.7042364245800348 3.1227571301029045e-07 -0.0983799775507039 -1.5824 0.7042387178666395 0.7042372872463831 3.105564448935283e-07 -0.09838046569811737 -1.5825 0.7042395878141531 0.70423814967209 3.0875676958197484e-07 -0.09838095369964206 -1.5826000000000002 0.7042404574815027 0.7042390118580882 3.068771223385669e-07 -0.09838144155532087 -1.5827 0.7042413268679151 0.7042398738053044 3.049179565853266e-07 -0.09838192926519665 -1.5828000000000002 0.7042421959726224 0.7042407355146608 3.0287974379233917e-07 -0.0983824168293122 -1.5829000000000002 0.7042430647948617 0.7042415969870746 3.007629734083639e-07 -0.09838290424771051 -1.583 0.7042439333338752 0.7042424582234568 2.9856815272899517e-07 -0.09838339152043425 -1.5831000000000002 0.7042448015889118 0.7042433192247132 2.962958067509458e-07 -0.09838387864752635 -1.5832 0.7042456695592247 0.7042441799917436 2.9394647808878016e-07 -0.09838436562902951 -1.5833000000000002 0.7042465372440747 0.7042450405254421 2.915207268153197e-07 -0.09838485246498663 -1.5834000000000001 0.7042474046427272 0.7042459008266961 2.89019130329804e-07 -0.09838533915544038 -1.5835 0.7042482717544549 0.7042467608963869 2.864422832191127e-07 -0.09838582570043362 -1.5836000000000001 0.7042491385785372 0.7042476207353892 2.837907971398046e-07 -0.09838631210000906 -1.5837 0.7042500051142597 0.7042484803445704 2.8106530067933955e-07 -0.09838679835420945 -1.5838 0.7042508713609154 0.704249339724792 2.7826643912709503e-07 -0.09838728446307754 -1.5839 0.7042517373178034 0.7042501988769074 2.753948744396717e-07 -0.09838777042665603 -1.584 0.7042526029842315 0.7042510578017631 2.724512849841543e-07 -0.09838825624498765 -1.5841 0.7042534683595139 0.7042519165001979 2.6943636543402816e-07 -0.09838874191811502 -1.5842 0.7042543334429725 0.7042527749730436 2.66350826602646e-07 -0.09838922744608093 -1.5843000000000003 0.7042551982339371 0.7042536332211236 2.6319539525587743e-07 -0.09838971282892797 -1.5844 0.7042560627317461 0.7042544912452531 2.5997081395945365e-07 -0.09839019806669888 -1.5845 0.7042569269357448 0.7042553490462395 2.5667784087080037e-07 -0.09839068315943622 -1.5846000000000002 0.7042577908452878 0.7042562066248823 2.5331724957250445e-07 -0.0983911681071827 -1.5847 0.7042586544597375 0.7042570639819714 2.4988982895435274e-07 -0.09839165290998084 -1.5848000000000002 0.7042595177784653 0.7042579211182893 2.4639638294271515e-07 -0.09839213756787336 -1.5849000000000002 0.7042603808008507 0.704258778034609 2.428377303687057e-07 -0.09839262208090277 -1.585 0.7042612435262834 0.7042596347316945 2.3921470473226014e-07 -0.09839310644911173 -1.5851000000000002 0.7042621059541607 0.7042604912103007 2.3552815403560245e-07 -0.09839359067254275 -1.5852 0.7042629680838903 0.7042613474711736 2.3177894058895587e-07 -0.09839407475123846 -1.5853000000000002 0.7042638299148885 0.7042622035150499 2.2796794080931493e-07 -0.09839455868524136 -1.5854000000000001 0.7042646914465813 0.7042630593426558 2.2409604497064528e-07 -0.098395042474594 -1.5855 0.7042655526784047 0.7042639149547086 2.2016415705816694e-07 -0.09839552611933892 -1.5856000000000001 0.7042664136098041 0.7042647703519155 2.16173194525493e-07 -0.09839600961951857 -1.5857 0.7042672742402353 0.7042656255349736 2.1212408806911554e-07 -0.09839649297517553 -1.5858 0.7042681345691637 0.7042664805045703 2.0801778144452499e-07 -0.09839697618635225 -1.5859 0.7042689945960652 0.7042673352613822 2.0385523122681826e-07 -0.09839745925309124 -1.586 0.704269854320426 0.7042681898060756 1.9963740659906248e-07 -0.09839794217543492 -1.5861 0.7042707137417432 0.7042690441393067 1.953652891059643e-07 -0.09839842495342582 -1.5862 0.7042715728595236 0.7042698982617204 1.9103987243529463e-07 -0.0983989075871063 -1.5863000000000003 0.7042724316732856 0.7042707521739512 1.8666216219931364e-07 -0.09839939007651885 -1.5864 0.7042732901825581 0.7042716058766224 1.8223317570231767e-07 -0.0983998724217058 -1.5865 0.7042741483868811 0.7042724593703467 1.7775394168390024e-07 -0.09840035462270966 -1.5866000000000002 0.7042750062858059 0.7042733126557251 1.7322550008649906e-07 -0.09840083667957276 -1.5867 0.7042758638788942 0.7042741657333476 1.6864890181253478e-07 -0.09840131859233744 -1.5868000000000002 0.7042767211657205 0.7042750186037928 1.6402520850930524e-07 -0.09840180036104618 -1.5869000000000002 0.7042775781458697 0.7042758712676278 1.5935549227755197e-07 -0.09840228198574127 -1.587 0.7042784348189383 0.7042767237254083 1.5464083546676277e-07 -0.09840276346646509 -1.5871000000000002 0.7042792911845348 0.7042775759776778 1.4988233037679932e-07 -0.09840324480325996 -1.5872 0.7042801472422795 0.7042784280249681 1.45081079039322e-07 -0.09840372599616815 -1.5873000000000002 0.7042810029918043 0.7042792798677991 1.4023819297145912e-07 -0.09840420704523202 -1.5874000000000001 0.7042818584327537 0.7042801315066791 1.353547929086596e-07 -0.09840468795049387 -1.5875 0.7042827135647833 0.7042809829421035 1.3043200849244263e-07 -0.09840516871199595 -1.5876000000000001 0.7042835683875618 0.7042818341745565 1.2547097810039487e-07 -0.09840564932978059 -1.5877000000000001 0.7042844229007696 0.7042826852045088 1.204728485235118e-07 -0.09840612980388999 -1.5878 0.7042852771040996 0.7042835360324196 1.1543877470598929e-07 -0.09840661013436643 -1.5879 0.7042861309972572 0.7042843866587352 1.103699194954233e-07 -0.09840709032125214 -1.588 0.7042869845799603 0.7042852370838896 1.0526745337566257e-07 -0.09840757036458934 -1.5881 0.7042878378519393 0.704286087308304 1.0013255417537503e-07 -0.09840805026442025 -1.5882 0.7042886908129373 0.704286937332387 9.496640681824764e-08 -0.09840853002078709 -1.5883000000000003 0.7042895434627101 0.7042877871565343 8.977020304196115e-08 -0.09840900963373199 -1.5884 0.7042903958010266 0.7042886367811287 8.454514111369549e-08 -0.09840948910329718 -1.5885 0.7042912478276682 0.7042894862065405 7.929242557859484e-08 -0.09840996842952485 -1.5886000000000002 0.7042920995424291 0.7042903354331265 7.40132669388438e-08 -0.09841044761245706 -1.5887 0.7042929509451172 0.7042911844612303 6.870888142294918e-08 -0.09841092665213597 -1.5888000000000002 0.7042938020355531 0.7042920332911833 6.338049068216334e-08 -0.0984114055486038 -1.5889000000000002 0.7042946528135701 0.704292881923303 5.802932151639795e-08 -0.0984118843019026 -1.589 0.704295503279015 0.7042937303578937 5.26566055758515e-08 -0.09841236291207447 -1.5891000000000002 0.7042963534317483 0.7042945785952468 4.726357908865775e-08 -0.09841284137916154 -1.5892 0.704297203271643 0.7042954266356404 4.185148258506466e-08 -0.09841331970320587 -1.5893000000000002 0.7042980527985857 0.7042962744793387 3.642156060600088e-08 -0.09841379788424949 -1.5894000000000001 0.7042989020124764 0.7042971221265932 3.097506140990747e-08 -0.09841427592233454 -1.5895 0.7042997509132282 0.7042979695776415 2.551323668997796e-08 -0.09841475381750298 -1.5896000000000001 0.7043005995007678 0.704298816832708 2.0037341287929e-08 -0.09841523156979687 -1.5897000000000001 0.7043014477750357 0.7042996638920035 1.4548632907770975e-08 -0.09841570917925824 -1.5898 0.7043022957359854 0.7043005107557254 9.048371829578628e-09 -0.09841618664592916 -1.5899 0.7043031433835838 0.7043013574240578 3.537820605047093e-09 -0.09841666396985155 -1.59 0.7043039907178117 0.7043022038971704 -1.981756210522878e-09 -0.09841714115106744 -1.5901 0.7043048377386634 0.7043030501752201 -7.50909236787306e-09 -0.09841761818961875 -1.5902 0.7043056844461462 0.7043038962583498 -1.3042920200476149e-08 -0.09841809508554747 -1.5903000000000003 0.7043065308402816 0.7043047421466893 -1.858197092420924e-08 -0.09841857183889556 -1.5904 0.7043073769211046 0.7043055878403541 -2.4124974923583203e-08 -0.09841904844970495 -1.5905 0.7043082226886634 0.7043064333394469 -2.967066203948994e-08 -0.09841952491801757 -1.5906000000000002 0.70430906814302 0.704307278644056 -3.521776186735798e-08 -0.09842000124387533 -1.5907 0.7043099132842499 0.7043081237542564 -4.076500404533341e-08 -0.09842047742732012 -1.5908000000000002 0.7043107581124424 0.7043089686701098 -4.6311118543883854e-08 -0.09842095346839387 -1.5909 0.7043116026276998 0.7043098133916639 -5.18548359570558e-08 -0.09842142936713841 -1.591 0.7043124468301386 0.7043106579189526 -5.739488779339316e-08 -0.09842190512359564 -1.5911000000000002 0.7043132907198888 0.704311502251997 -6.293000676376587e-08 -0.09842238073780743 -1.5912 0.7043141342970931 0.7043123463908039 -6.845892707666584e-08 -0.09842285620981558 -1.5913000000000002 0.7043149775619086 0.7043131903353668 -7.398038472106183e-08 -0.09842333153966194 -1.5914000000000001 0.7043158205145055 0.7043140340856657 -7.949311776108553e-08 -0.0984238067273883 -1.5915 0.7043166631550675 0.7043148776416671 -8.499586662009256e-08 -0.09842428177303647 -1.5916000000000001 0.7043175054837918 0.7043157210033242 -9.048737436775922e-08 -0.0984247566766483 -1.5917000000000001 0.704318347500889 0.7043165641705764 -9.596638701498544e-08 -0.09842523143826552 -1.5918 0.704319189206583 0.70431740714335 -1.014316537888485e-07 -0.09842570605792994 -1.5919 0.7043200306011109 0.7043182499215577 -1.0688192742577124e-07 -0.0984261805356833 -1.592 0.7043208716847232 0.704319092505099 -1.123159644508126e-07 -0.09842665487156736 -1.5921 0.7043217124576837 0.7043199348938605 -1.1773252546996849e-07 -0.09842712906562383 -1.5922 0.7043225529202692 0.7043207770877149 -1.2313037545119698e-07 -0.09842760311789445 -1.5923000000000003 0.7043233930727697 0.704321619086522 -1.285082839863616e-07 -0.09842807702842093 -1.5924 0.7043242329154886 0.7043224608901286 -1.338650255991447e-07 -0.098428550797245 -1.5925 0.7043250724487418 0.7043233024983682 -1.391993800121949e-07 -0.09842902442440829 -1.5926000000000002 0.7043259116728586 0.7043241439110612 -1.4451013242294808e-07 -0.09842949790995247 -1.5927 0.704326750588181 0.7043249851280153 -1.4979607377944848e-07 -0.09842997125391924 -1.5928000000000002 0.704327589195064 0.7043258261490257 -1.5505600105963913e-07 -0.09843044445635026 -1.5929 0.7043284274938751 0.7043266669738741 -1.6028871755065233e-07 -0.09843091751728719 -1.593 0.704329265484995 0.7043275076023296 -1.6549303310381402e-07 -0.09843139043677163 -1.5931000000000002 0.7043301031688161 0.7043283480341489 -1.7066776442607734e-07 -0.09843186321484516 -1.5932 0.7043309405457443 0.7043291882690758 -1.758117353263533e-07 -0.09843233585154948 -1.5933000000000002 0.7043317776161978 0.7043300283068417 -1.8092377700867912e-07 -0.09843280834692608 -1.5934000000000001 0.7043326143806068 0.7043308681471653 -1.8600272832028364e-07 -0.0984332807010166 -1.5935 0.7043334508394142 0.7043317077897535 -1.9104743601006113e-07 -0.09843375291386258 -1.5936000000000001 0.7043342869930749 0.7043325472343007 -1.9605675501133124e-07 -0.09843422498550562 -1.5937000000000001 0.7043351228420559 0.7043333864804888 -2.010295486812308e-07 -0.09843469691598725 -1.5938 0.7043359583868365 0.7043342255279883 -2.0596468906786125e-07 -0.09843516870534899 -1.5939 0.7043367936279077 0.704335064376457 -2.1086105718090553e-07 -0.09843564035363236 -1.594 0.7043376285657721 0.7043359030255409 -2.157175432102032e-07 -0.09843611186087886 -1.5941 0.7043384632009448 0.7043367414748749 -2.2053304679636732e-07 -0.09843658322713 -1.5942 0.7043392975339519 0.7043375797240818 -2.253064772875235e-07 -0.09843705445242731 -1.5943000000000003 0.7043401315653313 0.7043384177727725 -2.3003675398911017e-07 -0.09843752553681229 -1.5944 0.7043409652956323 0.7043392556205467 -2.3472280638592302e-07 -0.09843799648032626 -1.5945 0.704341798725415 0.704340093266993 -2.393635743953848e-07 -0.0984384672830108 -1.5946000000000002 0.7043426318552517 0.7043409307116881 -2.4395800860693706e-07 -0.0984389379449073 -1.5947 0.7043434646857251 0.7043417679541986 -2.485050705491876e-07 -0.0984394084660572 -1.5948000000000002 0.7043442972174284 0.7043426049940789 -2.530037328599133e-07 -0.09843987884650184 -1.5949 0.7043451294509668 0.7043434418308736 -2.5745297956708546e-07 -0.09844034908628274 -1.595 0.7043459613869555 0.704344278464116 -2.618518063039754e-07 -0.09844081918544126 -1.5951000000000002 0.7043467930260203 0.7043451148933286 -2.661992205624242e-07 -0.09844128914401873 -1.5952 0.7043476243687976 0.7043459511180239 -2.7049424185937587e-07 -0.09844175896205655 -1.5953000000000002 0.7043484554159343 0.7043467871377038 -2.7473590199361686e-07 -0.09844222863959612 -1.5954000000000002 0.7043492861680871 0.7043476229518597 -2.7892324528516754e-07 -0.09844269817667878 -1.5955 0.704350116625923 0.7043484585599735 -2.830553287487547e-07 -0.0984431675733458 -1.5956000000000001 0.7043509467901187 0.7043492939615164 -2.871312223227951e-07 -0.0984436368296385 -1.5957000000000001 0.7043517766613608 0.7043501291559505 -2.911500090671537e-07 -0.09844410594559827 -1.5958 0.7043526062403458 0.7043509641427279 -2.951107854198831e-07 -0.09844457492126638 -1.5959 0.7043534355277791 0.7043517989212911 -2.990126613394706e-07 -0.09844504375668406 -1.596 0.7043542645243759 0.7043526334910732 -3.0285476054076055e-07 -0.09844551245189265 -1.5961 0.7043550932308605 0.7043534678514985 -3.0663622063720197e-07 -0.09844598100693341 -1.5962 0.7043559216479662 0.7043543020019818 -3.1035619341146514e-07 -0.09844644942184758 -1.5963000000000003 0.7043567497764351 0.7043551359419288 -3.1401384497503626e-07 -0.09844691769667636 -1.5964 0.7043575776170181 0.7043559696707369 -3.176083559347509e-07 -0.09844738583146104 -1.5965 0.7043584051704748 0.7043568031877947 -3.211389215940219e-07 -0.09844785382624283 -1.5966000000000002 0.7043592324375728 0.7043576364924823 -3.246047521054951e-07 -0.09844832168106286 -1.5967 0.7043600594190884 0.7043584695841714 -3.2800507272084944e-07 -0.09844878939596238 -1.5968000000000002 0.7043608861158059 0.704359302462226 -3.313391238879415e-07 -0.09844925697098261 -1.5969 0.7043617125285173 0.7043601351260016 -3.346061614450946e-07 -0.09844972440616466 -1.597 0.7043625386580228 0.7043609675748463 -3.3780545679457097e-07 -0.09845019170154971 -1.5971000000000002 0.7043633645051294 0.7043617998081003 -3.4093629704828876e-07 -0.09845065885717891 -1.5972 0.7043641900706521 0.7043626318250966 -3.4399798525680536e-07 -0.09845112587309335 -1.5973000000000002 0.7043650153554133 0.7043634636251608 -3.4698984041625636e-07 -0.09845159274933422 -1.5974000000000002 0.7043658403602422 0.7043642952076112 -3.4991119775978907e-07 -0.09845205948594261 -1.5975 0.7043666650859746 0.7043651265717592 -3.5276140886858487e-07 -0.09845252608295957 -1.5976000000000001 0.7043674895334533 0.7043659577169099 -3.5553984178982034e-07 -0.09845299254042623 -1.5977000000000001 0.7043683137035279 0.7043667886423612 -3.582458811615674e-07 -0.09845345885838368 -1.5978 0.7043691375970542 0.7043676193474051 -3.6087892840014346e-07 -0.09845392503687295 -1.5979 0.7043699612148941 0.7043684498313268 -3.6343840179725584e-07 -0.09845439107593512 -1.598 0.7043707845579155 0.7043692800934063 -3.6592373666571865e-07 -0.09845485697561125 -1.5981 0.7043716076269919 0.704370110132917 -3.683343854643528e-07 -0.09845532273594233 -1.5982 0.7043724304230028 0.7043709399491269 -3.7066981788819175e-07 -0.0984557883569694 -1.5983000000000003 0.704373252946833 0.7043717695412982 -3.7292952103501475e-07 -0.09845625383873341 -1.5984 0.7043740751993726 0.7043725989086884 -3.7511299950249155e-07 -0.09845671918127541 -1.5985 0.7043748971815164 0.7043734280505497 -3.7721977546451013e-07 -0.09845718438463637 -1.5986000000000002 0.7043757188941648 0.704374256966129 -3.7924938878219905e-07 -0.09845764944885729 -1.5987 0.7043765403382223 0.7043750856546688 -3.812013971357664e-07 -0.09845811437397906 -1.5988000000000002 0.7043773615145981 0.7043759141154069 -3.8307537610776654e-07 -0.09845857916004268 -1.5989 0.7043781824242058 0.7043767423475771 -3.8487091928024464e-07 -0.09845904380708909 -1.599 0.7043790030679626 0.7043775703504086 -3.865876382694311e-07 -0.09845950831515915 -1.5991000000000002 0.7043798234467906 0.7043783981231269 -3.8822516288533615e-07 -0.09845997268429386 -1.5992 0.7043806435616148 0.7043792256649535 -3.897831411803221e-07 -0.09846043691453407 -1.5993000000000002 0.7043814634133639 0.7043800529751068 -3.912612395393089e-07 -0.0984609010059207 -1.5994000000000002 0.7043822830029702 0.7043808800528012 -3.926591427075299e-07 -0.09846136495849461 -1.5995 0.7043831023313685 0.7043817068972484 -3.9397655388073716e-07 -0.09846182877229664 -1.5996000000000001 0.7043839213994973 0.704382533507657 -3.952131948023463e-07 -0.09846229244736769 -1.5997000000000001 0.7043847402082972 0.7043833598832325 -3.9636880574955846e-07 -0.09846275598374854 -1.5998 0.704385558758712 0.7043841860231788 -3.9744314568601613e-07 -0.09846321938148007 -1.5999 0.7043863770516872 0.7043850119266963 -3.984359922201697e-07 -0.09846368264060315 -1.6 0.7043871950881706 0.7043858375929837 -3.9934714167466634e-07 -0.09846414576115846 -1.6001 0.704388012869112 0.7043866630212379 -4.0017640916267805e-07 -0.0984646087431869 -1.6002 0.7043888303954633 0.7043874882106536 -4.0092362857402364e-07 -0.09846507158672921 -1.6003000000000003 0.7043896476681774 0.7043883131604242 -4.0158865270006894e-07 -0.09846553429182618 -1.6004 0.7043904646882082 0.7043891378697418 -4.0217135312270447e-07 -0.09846599685851852 -1.6005 0.7043912814565121 0.7043899623377972 -4.0267162033230663e-07 -0.09846645928684705 -1.6006000000000002 0.704392097974045 0.7043907865637801 -4.030893637624322e-07 -0.0984669215768525 -1.6007 0.7043929142417642 0.7043916105468796 -4.0342451172736826e-07 -0.09846738372857555 -1.6008000000000002 0.7043937302606275 0.7043924342862845 -4.036770115192767e-07 -0.09846784574205694 -1.6009 0.7043945460315925 0.7043932577811831 -4.0384682933186644e-07 -0.09846830761733738 -1.601 0.7043953615556178 0.704394081030763 -4.039339503159045e-07 -0.09846876935445757 -1.6011000000000002 0.7043961768336612 0.7043949040342121 -4.039383785653383e-07 -0.09846923095345818 -1.6012 0.7043969918666804 0.7043957267907197 -4.0386013711035673e-07 -0.09846969241437989 -1.6013000000000002 0.7043978066556325 0.7043965492994736 -4.0369926794514566e-07 -0.09847015373726331 -1.6014000000000002 0.7043986212014743 0.7043973715596636 -4.0345583188911016e-07 -0.09847061492214915 -1.6015 0.7043994355051613 0.7043981935704802 -4.0312990871177456e-07 -0.09847107596907796 -1.6016000000000001 0.7044002495676482 0.7043990153311143 -4.027215970425768e-07 -0.09847153687809049 -1.6017000000000001 0.7044010633898883 0.7043998368407587 -4.022310143639296e-07 -0.09847199764922725 -1.6018000000000001 0.7044018769728329 0.7044006580986075 -4.0165829690019805e-07 -0.09847245828252885 -1.6019 0.7044026903174322 0.7044014791038564 -4.0100359971484423e-07 -0.09847291877803586 -1.602 0.7044035034246345 0.7044022998557032 -4.0026709659940485e-07 -0.09847337913578894 -1.6021 0.7044043162953855 0.7044031203533476 -3.99448979962469e-07 -0.0984738393558286 -1.6022 0.7044051289306292 0.7044039405959914 -3.985494609337614e-07 -0.09847429943819541 -1.6023000000000003 0.7044059413313064 0.7044047605828387 -3.9756876914209816e-07 -0.09847475938292988 -1.6024 0.704406753498356 0.704405580313097 -3.965071528125308e-07 -0.09847521919007253 -1.6025 0.7044075654327133 0.7044063997859759 -3.953648785789965e-07 -0.0984756788596639 -1.6026000000000002 0.704408377135311 0.7044072190006885 -3.9414223148431793e-07 -0.09847613839174452 -1.6027 0.7044091886070784 0.704408037956451 -3.9283951491081437e-07 -0.09847659778635487 -1.6028000000000002 0.7044099998489407 0.7044088566524829 -3.9145705046927937e-07 -0.09847705704353538 -1.6029 0.7044108108618204 0.7044096750880078 -3.899951779434696e-07 -0.09847751616332659 -1.603 0.7044116216466356 0.7044104932622527 -3.8845425522765487e-07 -0.09847797514576895 -1.6031000000000002 0.7044124322043004 0.7044113111744487 -3.8683465818784013e-07 -0.0984784339909029 -1.6032 0.7044132425357246 0.7044121288238314 -3.8513678061319334e-07 -0.09847889269876892 -1.6033000000000002 0.7044140526418133 0.7044129462096403 -3.833610341050231e-07 -0.09847935126940735 -1.6034000000000002 0.7044148625234679 0.70441376333112 -3.815078479935119e-07 -0.09847980970285869 -1.6035 0.7044156721815835 0.7044145801875197 -3.7957766917812163e-07 -0.09848026799916326 -1.6036000000000001 0.7044164816170515 0.7044153967780933 -3.7757096212759356e-07 -0.09848072615836151 -1.6037000000000001 0.7044172908307575 0.7044162131021001 -3.754882086232092e-07 -0.0984811841804938 -1.6038000000000001 0.7044180998235816 0.7044170291588052 -3.7332990777266817e-07 -0.09848164206560049 -1.6039 0.7044189085963988 0.7044178449474785 -3.710965758435547e-07 -0.09848209981372195 -1.604 0.7044197171500779 0.7044186604673959 -3.687887461245598e-07 -0.09848255742489855 -1.6041 0.7044205254854821 0.704419475717839 -3.664069687797644e-07 -0.09848301489917057 -1.6042 0.7044213336034686 0.704420290698096 -3.639518108208839e-07 -0.09848347223657841 -1.6043000000000003 0.7044221415048875 0.7044211054074607 -3.6142385585052894e-07 -0.09848392943716233 -1.6044 0.7044229491905833 0.7044219198452337 -3.588237039858777e-07 -0.09848438650096261 -1.6045 0.7044237566613936 0.7044227340107222 -3.561519717268369e-07 -0.09848484342801957 -1.6046 0.7044245639181488 0.7044235479032401 -3.5340929174787483e-07 -0.09848530021837348 -1.6047 0.7044253709616728 0.704424361522108 -3.5059631284251047e-07 -0.09848575687206457 -1.6048000000000002 0.7044261777927823 0.7044251748666541 -3.4771369966657417e-07 -0.09848621338913312 -1.6049 0.7044269844122866 0.7044259879362136 -3.447621326133077e-07 -0.0984866697696194 -1.605 0.7044277908209875 0.7044268007301291 -3.4174230777866965e-07 -0.09848712601356363 -1.6051000000000002 0.7044285970196789 0.7044276132477507 -3.386549365796965e-07 -0.098487582121006 -1.6052 0.7044294030091469 0.704428425488437 -3.3550074576838007e-07 -0.0984880380919867 -1.6053000000000002 0.7044302087901704 0.7044292374515536 -3.3228047713329545e-07 -0.09848849392654598 -1.6054000000000002 0.7044310143635193 0.7044300491364748 -3.28994887416334e-07 -0.09848894962472404 -1.6055 0.7044318197299552 0.7044308605425826 -3.256447481114755e-07 -0.09848940518656095 -1.6056000000000001 0.7044326248902318 0.7044316716692683 -3.222308452219269e-07 -0.09848986061209697 -1.6057000000000001 0.7044334298450942 0.7044324825159313 -3.1875397921155013e-07 -0.09849031590137225 -1.6058000000000001 0.7044342345952779 0.704433293081979 -3.152149646648561e-07 -0.09849077105442684 -1.6059 0.7044350391415102 0.7044341033668287 -3.1161463019679925e-07 -0.09849122607130094 -1.606 0.7044358434845093 0.7044349133699065 -3.079538181821606e-07 -0.09849168095203466 -1.6061 0.7044366476249841 0.7044357230906473 -3.042333846653422e-07 -0.09849213569666807 -1.6062 0.7044374515636342 0.7044365325284954 -3.0045419906199466e-07 -0.09849259030524128 -1.6063000000000003 0.7044382553011499 0.704437341682905 -2.9661714399595307e-07 -0.09849304477779444 -1.6064 0.704439058838211 0.7044381505533391 -2.927231151049481e-07 -0.0984934991143675 -1.6065 0.7044398621754885 0.7044389591392712 -2.887730207977446e-07 -0.0984939533150006 -1.6066 0.704440665313643 0.7044397674401844 -2.847677821084249e-07 -0.09849440737973375 -1.6067 0.7044414682533257 0.7044405754555714 -2.807083323529136e-07 -0.09849486130860702 -1.6068000000000002 0.7044422709951769 0.7044413831849357 -2.765956170630579e-07 -0.09849531510166043 -1.6069 0.7044430735398269 0.7044421906277899 -2.7243059366396927e-07 -0.09849576875893398 -1.607 0.7044438758878959 0.7044429977836582 -2.6821423129708144e-07 -0.09849622228046766 -1.6071000000000002 0.7044446780399927 0.7044438046520749 -2.6394751057728927e-07 -0.09849667566630145 -1.6072 0.7044454799967165 0.7044446112325846 -2.5963142337784295e-07 -0.09849712891647538 -1.6073000000000002 0.7044462817586551 0.7044454175247431 -2.552669725840173e-07 -0.0984975820310294 -1.6074000000000002 0.7044470833263854 0.7044462235281164 -2.5085517189535333e-07 -0.0984980350100034 -1.6075 0.7044478847004738 0.704447029242282 -2.4639704550993846e-07 -0.0984984878534374 -1.6076000000000001 0.7044486858814749 0.7044478346668286 -2.4189362797868985e-07 -0.09849894056137132 -1.6077000000000001 0.7044494868699327 0.7044486398013554 -2.3734596391739027e-07 -0.09849939313384505 -1.6078000000000001 0.7044502876663797 0.7044494446454737 -2.3275510778811292e-07 -0.09849984557089858 -1.6079 0.7044510882713367 0.7044502491988051 -2.2812212361472683e-07 -0.09850029787257174 -1.608 0.7044518886853133 0.7044510534609836 -2.234480847816689e-07 -0.0985007500389044 -1.6081 0.7044526889088072 0.704451857431655 -2.1873407376332699e-07 -0.0985012020699365 -1.6082 0.7044534889423046 0.7044526611104753 -2.1398118188117876e-07 -0.09850165396570781 -1.6083000000000003 0.7044542887862797 0.7044534644971141 -2.0919050903664416e-07 -0.09850210572625825 -1.6084 0.7044550884411954 0.7044542675912517 -2.0436316347516303e-07 -0.09850255735162769 -1.6085 0.704455887907502 0.7044550703925805 -1.995002615225172e-07 -0.09850300884185592 -1.6086 0.7044566871856377 0.7044558729008052 -1.9460292730380524e-07 -0.0985034601969828 -1.6087 0.7044574862760289 0.7044566751156425 -1.896722925560923e-07 -0.09850391141704808 -1.6088000000000002 0.7044582851790897 0.704457477036821 -1.8470949626411826e-07 -0.09850436250209162 -1.6089 0.7044590838952218 0.7044582786640821 -1.797156844660086e-07 -0.09850481345215317 -1.609 0.7044598824248145 0.7044590799971788 -1.746920099861271e-07 -0.09850526426727248 -1.6091000000000002 0.7044606807682448 0.7044598810358771 -1.6963963214711164e-07 -0.09850571494748933 -1.6092 0.7044614789258771 0.7044606817799552 -1.6455971652527823e-07 -0.09850616549284347 -1.6093000000000002 0.7044622768980633 0.7044614822292041 -1.5945343463316664e-07 -0.09850661590337464 -1.6094000000000002 0.7044630746851428 0.7044622823834273 -1.5432196371831242e-07 -0.09850706617912262 -1.6095 0.7044638722874419 0.7044630822424405 -1.4916648644405783e-07 -0.0985075163201271 -1.6096000000000001 0.7044646697052748 0.7044638818060724 -1.4398819063281276e-07 -0.09850796632642773 -1.6097000000000001 0.7044654669389419 0.7044646810741646 -1.387882689937031e-07 -0.09850841619806423 -1.6098000000000001 0.7044662639887317 0.7044654800465714 -1.3356791883113728e-07 -0.09850886593507632 -1.6099 0.7044670608549197 0.7044662787231601 -1.2832834179674069e-07 -0.0985093155375037 -1.61 0.7044678575377679 0.7044670771038103 -1.2307074359965697e-07 -0.09850976500538591 -1.6101 0.704468654037526 0.7044678751884152 -1.1779633372031861e-07 -0.09851021433876271 -1.6102 0.70446945035443 0.7044686729768808 -1.1250632514676895e-07 -0.09851066353767365 -1.6103000000000003 0.7044702464887035 0.7044694704691258 -1.0720193408496337e-07 -0.09851111260215842 -1.6104 0.7044710424405567 0.7044702676650823 -1.0188437968555036e-07 -0.09851156153225664 -1.6105 0.7044718382101867 0.7044710645646952 -9.655488376631577e-08 -0.09851201032800787 -1.6106 0.7044726337977777 0.7044718611679229 -9.121467052248394e-08 -0.09851245898945175 -1.6107 0.7044734292035004 0.7044726574747364 -8.586496625523354e-08 -0.09851290751662782 -1.6108000000000002 0.7044742244275128 0.7044734534851197 -8.050699907852926e-08 -0.09851335590957568 -1.6109 0.7044750194699592 0.7044742491990708 -7.514199864937232e-08 -0.09851380416833488 -1.611 0.7044758143309708 0.7044750446165999 -6.977119588287214e-08 -0.09851425229294497 -1.6111000000000002 0.704476609010666 0.7044758397377311 -6.439582265994545e-08 -0.09851470028344547 -1.6112 0.7044774035091497 0.7044766345625013 -5.901711156146988e-08 -0.09851514813987593 -1.6113000000000002 0.7044781978265133 0.7044774290909606 -5.3636295571212605e-08 -0.09851559586227586 -1.6114000000000002 0.7044789919628357 0.7044782233231722 -4.825460780055139e-08 -0.09851604345068472 -1.6115 0.7044797859181819 0.7044790172592128 -4.287328120490151e-08 -0.09851649090514204 -1.6116000000000001 0.7044805796926041 0.7044798108991721 -3.749354830008848e-08 -0.09851693822568736 -1.6117000000000001 0.704481373286141 0.7044806042431526 -3.211664088148547e-08 -0.09851738541236002 -1.6118000000000001 0.7044821666988184 0.7044813972912707 -2.674378974287968e-08 -0.09851783246519959 -1.6119 0.7044829599306484 0.7044821900436554 -2.1376224389971915e-08 -0.09851827938424546 -1.612 0.7044837529816306 0.7044829825004488 -1.6015172765206087e-08 -0.09851872616953705 -1.6121 0.7044845458517511 0.7044837746618063 -1.0661860964846642e-08 -0.0985191728211138 -1.6122 0.704485338540983 0.7044845665278961 -5.317512956001802e-09 -0.0985196193390151 -1.6123000000000003 0.7044861310492864 0.7044853580989006 1.6649702450077797e-11 -0.09852006572328048 -1.6124 0.704486923376608 0.704486149375013 5.339408133513135e-09 -0.09852051197394915 -1.6125 0.7044877155228818 0.7044869403564412 1.06495464209308e-08 -0.0985209580910606 -1.6126 0.7044885074880284 0.7044877310434061 1.5945851903655106e-08 -0.09852140407465411 -1.6127 0.704489299271956 0.7044885214361408 2.1227115428248955e-08 -0.0985218499247692 -1.6128000000000002 0.7044900908745595 0.7044893115348915 2.6492131634248128e-08 -0.09852229564144502 -1.6129 0.704490882295721 0.7044901013399172 3.173969924039066e-08 -0.09852274122472103 -1.613 0.70449167353531 0.70449089085149 3.6968621308294813e-08 -0.09852318667463655 -1.6131000000000002 0.7044924645931825 0.7044916800698942 4.2177705513943287e-08 -0.0985236319912308 -1.6132 0.704493255469183 0.7044924689954271 4.736576440789175e-08 -0.09852407717454319 -1.6133000000000002 0.7044940461631419 0.7044932576283985 5.253161572404963e-08 -0.0985245222246129 -1.6134000000000002 0.7044948366748784 0.7044940459691312 5.767408261386775e-08 -0.09852496714147932 -1.6135 0.704495627004198 0.70449483401796 6.279199392389412e-08 -0.09852541192518162 -1.6136000000000001 0.7044964171508945 0.7044956217752323 6.788418445424771e-08 -0.09852585657575914 -1.6137000000000001 0.7044972071147485 0.7044964092413079 7.29494952569909e-08 -0.09852630109325104 -1.6138000000000001 0.7044979968955289 0.704497196416559 7.798677386164354e-08 -0.0985267454776966 -1.6139000000000001 0.7044987864929925 0.7044979833013697 8.299487455273868e-08 -0.09852718972913506 -1.614 0.7044995759068831 0.7044987698961365 8.797265863350057e-08 -0.09852763384760554 -1.6141 0.7045003651369333 0.7044995562012679 9.29189946687059e-08 -0.09852807783314736 -1.6142 0.7045011541828627 0.7045003422171846 9.783275877264797e-08 -0.09852852168579959 -1.6143000000000003 0.7045019430443799 0.7045011279443194 1.0271283483118121e-07 -0.09852896540560152 -1.6144 0.7045027317211807 0.7045019133831161 1.0755811478274646e-07 -0.09852940899259226 -1.6145 0.7045035202129498 0.7045026985340311 1.1236749884388497e-07 -0.09852985244681095 -1.6146 0.7045043085193601 0.7045034833975319 1.171398957659775e-07 -0.09853029576829678 -1.6147 0.7045050966400725 0.7045042679740978 1.218742231093306e-07 -0.0985307389570888 -1.6148000000000002 0.7045058845747372 0.7045050522642196 1.2656940746175183e-07 -0.09853118201322625 -1.6149 0.704506672322992 0.7045058362683991 1.312243846779415e-07 -0.09853162493674814 -1.615 0.7045074598844641 0.7045066199871499 1.3583810013276243e-07 -0.09853206772769359 -1.6151000000000002 0.7045082472587691 0.7045074034209964 1.404095089571622e-07 -0.09853251038610172 -1.6152 0.7045090344455123 0.704508186570474 1.4493757627409565e-07 -0.09853295291201157 -1.6153000000000002 0.7045098214442868 0.7045089694361291 1.494212774691417e-07 -0.09853339530546219 -1.6154000000000002 0.7045106082546759 0.7045097520185193 1.538595983292812e-07 -0.09853383756649273 -1.6155 0.7045113948762516 0.7045105343182123 1.5825153537596393e-07 -0.09853427969514214 -1.6156000000000001 0.7045121813085757 0.7045113163357868 1.6259609601776415e-07 -0.09853472169144953 -1.6157000000000001 0.7045129675511987 0.7045120980718316 1.6689229881405865e-07 -0.09853516355545379 -1.6158000000000001 0.7045137536036616 0.7045128795269464 1.7113917366931575e-07 -0.09853560528719404 -1.6159000000000001 0.7045145394654944 0.7045136607017406 1.7533576209677326e-07 -0.09853604688670922 -1.616 0.7045153251362176 0.7045144415968341 1.7948111739191086e-07 -0.09853648835403839 -1.6161 0.7045161106153415 0.7045152222128561 1.8357430486837245e-07 -0.09853692968922043 -1.6162 0.7045168959023662 0.7045160025504467 1.8761440206266355e-07 -0.09853737089229439 -1.6163000000000003 0.7045176809967826 0.7045167826102551 1.9160049890762365e-07 -0.09853781196329925 -1.6164 0.7045184658980712 0.7045175623929396 1.9553169800304304e-07 -0.09853825290227383 -1.6165 0.7045192506057039 0.7045183418991686 1.9940711476831852e-07 -0.09853869370925714 -1.6166 0.7045200351191427 0.7045191211296196 2.032258776610285e-07 -0.09853913438428807 -1.6167 0.7045208194378407 0.7045199000849791 2.0698712838856936e-07 -0.09853957492740553 -1.6168000000000002 0.7045216035612417 0.704520678765943 2.1069002205040266e-07 -0.09854001533864842 -1.6169 0.7045223874887808 0.7045214571732157 2.143337273739776e-07 -0.09854045561805563 -1.617 0.7045231712198843 0.7045222353075103 2.1791742688820337e-07 -0.09854089576566603 -1.6171000000000002 0.7045239547539699 0.704523013169549 2.2144031709692147e-07 -0.09854133578151854 -1.6172 0.7045247380904469 0.7045237907600619 2.249016086766642e-07 -0.09854177566565196 -1.6173000000000002 0.7045255212287163 0.7045245680797871 2.2830052662931033e-07 -0.09854221541810515 -1.6174000000000002 0.7045263041681706 0.7045253451294712 2.3163631049372135e-07 -0.09854265503891692 -1.6175 0.7045270869081949 0.704526121909869 2.349082144498249e-07 -0.09854309452812612 -1.6176000000000001 0.7045278694481658 0.7045268984217424 2.3811550757535382e-07 -0.0985435338857715 -1.6177000000000001 0.7045286517874534 0.7045276746658615 2.41257473922174e-07 -0.09854397311189195 -1.6178000000000001 0.7045294339254187 0.7045284506430037 2.4433341275220677e-07 -0.09854441220652616 -1.6179000000000001 0.7045302158614168 0.7045292263539538 2.473426386137567e-07 -0.098544851169713 -1.618 0.7045309975947947 0.7045300017995031 2.5028448154967853e-07 -0.09854529000149116 -1.6181 0.7045317791248927 0.704530776980451 2.5315828725697154e-07 -0.09854572870189944 -1.6182 0.7045325604510445 0.7045315518976024 2.5596341719086313e-07 -0.09854616727097655 -1.6183 0.7045333415725767 0.70453232655177 2.586992487174644e-07 -0.09854660570876128 -1.6184 0.70453412248881 0.704533100943772 2.613651752733648e-07 -0.0985470440152923 -1.6185 0.704534903199058 0.7045338750744334 2.63960606490532e-07 -0.09854748219060828 -1.6186 0.7045356837026286 0.7045346489445853 2.664849683142734e-07 -0.09854792023474797 -1.6187 0.7045364639988242 0.7045354225550644 2.6893770311425813e-07 -0.09854835814775008 -1.6188000000000002 0.7045372440869405 0.7045361959067138 2.713182698510508e-07 -0.09854879592965327 -1.6189 0.704538023966268 0.7045369690003811 2.736261441940724e-07 -0.09854923358049616 -1.619 0.7045388036360918 0.7045377418369206 2.7586081857017275e-07 -0.09854967110031748 -1.6191000000000002 0.7045395830956918 0.7045385144171907 2.780218023579195e-07 -0.09855010848915578 -1.6192 0.7045403623443431 0.7045392867420553 2.8010862197086484e-07 -0.0985505457470498 -1.6193000000000002 0.704541141381315 0.7045400588123834 2.8212082091305657e-07 -0.0985509828740381 -1.6194000000000002 0.7045419202058729 0.7045408306290482 2.8405795991781613e-07 -0.09855141987015928 -1.6195 0.7045426988172777 0.7045416021929272 2.8591961708651636e-07 -0.09855185673545196 -1.6196000000000002 0.7045434772147856 0.7045423735049028 2.8770538790245936e-07 -0.09855229346995473 -1.6197000000000001 0.7045442553976489 0.7045431445658612 2.8941488534189874e-07 -0.09855273007370617 -1.6198000000000001 0.7045450333651154 0.7045439153766926 2.9104773997118416e-07 -0.09855316654674481 -1.6199000000000001 0.70454581111643 0.7045446859382908 2.926036000647225e-07 -0.09855360288910925 -1.62 0.7045465886508335 0.704545456251553 2.940821315841613e-07 -0.09855403910083799 -1.6201 0.7045473659675637 0.7045462263173801 2.954830183032886e-07 -0.09855447518196958 -1.6202 0.7045481430658547 0.7045469961366759 2.968059619398722e-07 -0.09855491113254256 -1.6203 0.7045489199449377 0.7045477657103474 2.980506820723927e-07 -0.09855534695259544 -1.6204 0.7045496966040417 0.7045485350393039 2.992169163412717e-07 -0.09855578264216668 -1.6205 0.7045504730423924 0.7045493041244577 3.003044204211158e-07 -0.0985562182012948 -1.6206 0.7045512492592132 0.7045500729667233 3.01312968097045e-07 -0.09855665363001827 -1.6207 0.7045520252537256 0.7045508415670176 3.022423513063255e-07 -0.0985570889283756 -1.6208000000000002 0.7045528010251487 0.7045516099262592 3.030923801869423e-07 -0.09855752409640517 -1.6209 0.7045535765727002 0.7045523780453686 3.038628830775991e-07 -0.09855795913414549 -1.621 0.7045543518955957 0.7045531459252679 3.0455370667731296e-07 -0.09855839404163495 -1.6211000000000002 0.7045551269930499 0.7045539135668804 3.051647158719417e-07 -0.09855882881891204 -1.6212 0.7045559018642753 0.7045546809711309 3.056957939492899e-07 -0.09855926346601504 -1.6213000000000002 0.7045566765084845 0.7045554481389453 3.061468425089031e-07 -0.09855969798298247 -1.6214000000000002 0.7045574509248886 0.70455621507125 3.065177815661513e-07 -0.09856013236985267 -1.6215 0.7045582251126983 0.7045569817689721 3.068085494134509e-07 -0.09856056662666408 -1.6216000000000002 0.7045589990711234 0.7045577482330392 3.070191028423097e-07 -0.098561000753455 -1.6217000000000001 0.704559772799374 0.7045585144643791 3.071494169698541e-07 -0.0985614347502638 -1.6218000000000001 0.7045605462966598 0.7045592804639191 3.071994852874016e-07 -0.09856186861712882 -1.6219000000000001 0.7045613195621908 0.7045600462325876 3.0716931971597194e-07 -0.09856230235408844 -1.622 0.7045620925951772 0.7045608117713112 3.0705895054383703e-07 -0.09856273596118093 -1.6221 0.7045628653948297 0.7045615770810172 3.068684263987653e-07 -0.09856316943844465 -1.6222 0.7045636379603598 0.704562342162631 3.0659781431047195e-07 -0.09856360278591783 -1.6223 0.7045644102909798 0.7045631070170777 3.0624719960653524e-07 -0.09856403600363879 -1.6224 0.7045651823859037 0.7045638716452811 3.0581668590545785e-07 -0.09856446909164585 -1.6225 0.7045659542443459 0.7045646360481638 3.0530639515136127e-07 -0.09856490204997721 -1.6226 0.7045667258655228 0.7045654002266466 3.047164674613301e-07 -0.09856533487867122 -1.6227 0.7045674972486524 0.704566164181649 3.0404706122255654e-07 -0.09856576757776608 -1.6228000000000002 0.704568268392955 0.7045669279140878 3.032983529258071e-07 -0.09856620014730004 -1.6229 0.7045690392976525 0.7045676914248782 3.0247053722093353e-07 -0.09856663258731126 -1.623 0.704569809961969 0.704568454714933 3.015638268058507e-07 -0.09856706489783804 -1.6231000000000002 0.7045705803851314 0.7045692177851628 3.0057845245429204e-07 -0.09856749707891854 -1.6232 0.7045713505663693 0.7045699806364747 2.9951466280764283e-07 -0.098567929130591 -1.6233000000000002 0.7045721205049149 0.7045707432697736 2.9837272446514573e-07 -0.09856836105289354 -1.6234000000000002 0.7045728902000035 0.7045715056859612 2.971529218034896e-07 -0.09856879284586435 -1.6235 0.7045736596508738 0.7045722678859352 2.9585555698374844e-07 -0.0985692245095416 -1.6236000000000002 0.7045744288567676 0.7045730298705912 2.9448094986811446e-07 -0.09856965604396341 -1.6237000000000001 0.704575197816931 0.7045737916408201 2.9302943788805935e-07 -0.09857008744916797 -1.6238000000000001 0.704575966530613 0.704574553197509 2.9150137603045634e-07 -0.09857051872519335 -1.6239000000000001 0.7045767349970674 0.7045753145415415 2.8989713667798567e-07 -0.09857094987207776 -1.624 0.7045775032155515 0.7045760756737964 2.882171096021957e-07 -0.09857138088985914 -1.6241 0.7045782711853275 0.7045768365951489 2.864617018108473e-07 -0.09857181177857577 -1.6242 0.7045790389056619 0.7045775973064685 2.8463133746464697e-07 -0.0985722425382656 -1.6243 0.7045798063758257 0.7045783578086209 2.8272645775928584e-07 -0.09857267316896676 -1.6244 0.7045805735950956 0.7045791181024665 2.807475208629895e-07 -0.09857310367071735 -1.6245 0.7045813405627523 0.7045798781888604 2.7869500173610673e-07 -0.09857353404355533 -1.6246 0.7045821072780828 0.7045806380686526 2.7656939213804854e-07 -0.09857396428751883 -1.6247 0.7045828737403785 0.7045813977426874 2.7437120037748786e-07 -0.09857439440264577 -1.6248000000000002 0.7045836399489376 0.7045821572118038 2.7210095123603173e-07 -0.09857482438897427 -1.6249 0.7045844059030628 0.7045829164768347 2.6975918585026015e-07 -0.09857525424654226 -1.625 0.7045851716020639 0.7045836755386072 2.673464616353982e-07 -0.0985756839753878 -1.6251000000000002 0.7045859370452564 0.7045844343979422 2.648633520771493e-07 -0.09857611357554885 -1.6252 0.7045867022319621 0.7045851930556537 2.623104466206727e-07 -0.09857654304706343 -1.6253000000000002 0.704587467161509 0.7045859515125499 2.5968835053874484e-07 -0.09857697238996942 -1.6254000000000002 0.7045882318332322 0.7045867097694317 2.5699768477216445e-07 -0.09857740160430477 -1.6255 0.7045889962464734 0.7045874678270939 2.5423908579791377e-07 -0.09857783069010749 -1.6256000000000002 0.7045897604005815 0.7045882256863236 2.514132054834417e-07 -0.0985782596474155 -1.6257000000000001 0.7045905242949122 0.704588983347901 2.4852071086461924e-07 -0.09857868847626666 -1.6258000000000001 0.7045912879288285 0.7045897408125991 2.4556228415267833e-07 -0.09857911717669897 -1.6259000000000001 0.7045920513017014 0.704590498081183 2.425386223942061e-07 -0.09857954574875029 -1.626 0.704592814412909 0.7045912551544102 2.3945043740175587e-07 -0.09857997419245847 -1.6261 0.7045935772618372 0.7045920120330309 2.3629845557343598e-07 -0.09858040250786139 -1.6262 0.7045943398478803 0.7045927687177871 2.3308341767780405e-07 -0.09858083069499701 -1.6263 0.7045951021704402 0.704593525209412 2.29806078784478e-07 -0.0985812587539031 -1.6264 0.704595864228927 0.7045942815086315 2.2646720793106923e-07 -0.09858168668461753 -1.6265 0.7045966260227594 0.7045950376161625 2.230675881231825e-07 -0.09858211448717812 -1.6266 0.7045973875513648 0.7045957935327133 2.1960801600134916e-07 -0.09858254216162271 -1.6267 0.7045981488141788 0.704596549258984 2.1608930173000473e-07 -0.09858296970798908 -1.6268000000000002 0.7045989098106462 0.7045973047956655 2.1251226879279161e-07 -0.09858339712631506 -1.6269 0.7045996705402209 0.7045980601434396 2.0887775377051443e-07 -0.09858382441663845 -1.627 0.704600431002365 0.704598815302979 2.051866062197094e-07 -0.098584251578997 -1.6271000000000002 0.7046011911965508 0.7045995702749476 2.014396883708025e-07 -0.09858467861342848 -1.6272 0.7046019511222597 0.7046003250599991 1.9763787506565933e-07 -0.09858510551997067 -1.6273000000000002 0.7046027107789825 0.7046010796587785 1.9378205338635435e-07 -0.09858553229866134 -1.6274000000000002 0.7046034701662193 0.7046018340719205 1.8987312257190414e-07 -0.09858595894953814 -1.6275 0.7046042292834804 0.7046025883000501 1.8591199377540613e-07 -0.09858638547263884 -1.6276000000000002 0.7046049881302863 0.7046033423437827 1.8189958982811616e-07 -0.09858681186800121 -1.6277000000000001 0.7046057467061665 0.7046040962037234 1.7783684506250674e-07 -0.09858723813566285 -1.6278000000000001 0.7046065050106616 0.7046048498804676 1.7372470506246684e-07 -0.09858766427566155 -1.6279000000000001 0.7046072630433216 0.7046056033745995 1.6956412646901287e-07 -0.09858809028803497 -1.628 0.7046080208037074 0.704606356686694 1.653560767408968e-07 -0.09858851617282073 -1.6281 0.7046087782913903 0.7046071098173147 1.6110153391521442e-07 -0.09858894193005655 -1.6282 0.704609535505952 0.7046078627670147 1.568014864061773e-07 -0.09858936755977998 -1.6283 0.7046102924469853 0.7046086155363368 1.5245693278653771e-07 -0.09858979306202884 -1.6284 0.704611049114093 0.7046093681258123 1.480688815447273e-07 -0.09859021843684056 -1.6285 0.7046118055068895 0.7046101205359622 1.4363835080383192e-07 -0.09859064368425284 -1.6286 0.7046125616250002 0.7046108727672964 1.3916636815852756e-07 -0.09859106880430334 -1.6287 0.7046133174680609 0.7046116248203133 1.3465397040446359e-07 -0.0985914937970296 -1.6288000000000002 0.7046140730357195 0.7046123766955001 1.3010220326417632e-07 -0.09859191866246923 -1.6289 0.7046148283276346 0.7046131283933333 1.2551212123443345e-07 -0.0985923434006598 -1.629 0.7046155833434757 0.7046138799142772 1.208847872462282e-07 -0.09859276801163881 -1.6291000000000002 0.7046163380829253 0.7046146312587849 1.1622127246008196e-07 -0.0985931924954439 -1.6292 0.7046170925456758 0.704615382427298 1.1152265602665246e-07 -0.09859361685211257 -1.6293000000000002 0.7046178467314326 0.7046161334202468 1.0679002482999467e-07 -0.0985940410816824 -1.6294000000000002 0.7046186006399114 0.7046168842380488 1.0202447322735231e-07 -0.09859446518419085 -1.6295 0.7046193542708407 0.7046176348811106 9.722710279935765e-08 -0.09859488915967543 -1.6296000000000002 0.7046201076239607 0.7046183853498269 9.2399022121048e-08 -0.09859531300817369 -1.6297000000000001 0.7046208606990232 0.7046191356445796 8.754134645308498e-08 -0.09859573672972305 -1.6298000000000001 0.7046216134957923 0.7046198857657396 8.265519753185291e-08 -0.09859616032436108 -1.6299000000000001 0.7046223660140443 0.7046206357136651 7.774170329016838e-08 -0.09859658379212517 -1.63 0.7046231182535669 0.7046213854887019 7.280199759880646e-08 -0.09859700713305279 -1.6301 0.7046238702141611 0.7046221350911841 6.783722000629211e-08 -0.09859743034718141 -1.6302 0.7046246218956389 0.7046228845214335 6.28485154821612e-08 -0.09859785343454841 -1.6303 0.7046253732978256 0.7046236337797596 5.7837034144608834e-08 -0.09859827639519132 -1.6304 0.7046261244205584 0.7046243828664587 5.280393098987257e-08 -0.09859869922914744 -1.6305 0.7046268752636871 0.7046251317818157 4.775036565630997e-08 -0.09859912193645425 -1.6306 0.7046276258270735 0.7046258805261025 4.267750210347476e-08 -0.0985995445171491 -1.6307 0.7046283761105925 0.7046266290995784 3.758650840048061e-08 -0.09859996697126935 -1.6308000000000002 0.704629126114131 0.7046273775024903 3.247855641895503e-08 -0.09860038929885241 -1.6309 0.704629875837589 0.7046281257350726 2.7354821591912826e-08 -0.09860081149993564 -1.631 0.7046306252808787 0.7046288737975468 2.2216482613648947e-08 -0.0986012335745564 -1.6311000000000002 0.7046313744439253 0.704629621690122 1.7064721190805654e-08 -0.09860165552275202 -1.6312 0.7046321233266662 0.7046303694129945 1.1900721763082045e-08 -0.09860207734455985 -1.6313000000000002 0.7046328719290514 0.7046311169663475 6.72567123174983e-09 -0.0986024990400171 -1.6314000000000002 0.7046336202510444 0.7046318643503522 1.5407586829649378e-09 -0.09860292060916119 -1.6315 0.7046343682926208 0.7046326115651662 -3.6528248750430925e-09 -0.09860334205202936 -1.6316000000000002 0.704635116053769 0.7046333586109348 -8.853886799935207e-09 -0.09860376336865892 -1.6317000000000002 0.7046358635344905 0.7046341054877907 -1.4061233075037677e-08 -0.09860418455908715 -1.6318000000000001 0.7046366107347991 0.7046348521958531 -1.9273668589933624e-08 -0.09860460562335129 -1.6319000000000001 0.7046373576547218 0.7046355987352291 -2.4489997418018772e-08 -0.09860502656148862 -1.632 0.7046381042942984 0.7046363451060123 -2.9709023081263622e-08 -0.09860544737353638 -1.6321 0.704638850653581 0.7046370913082838 -3.492954883557546e-08 -0.09860586805953174 -1.6322 0.704639596732635 0.704637837342112 -4.015037793870472e-08 -0.09860628861951198 -1.6323 0.7046403425315384 0.7046385832075525 -4.537031392346392e-08 -0.09860670905351432 -1.6324 0.7046410880503818 0.7046393289046475 -5.058816087571711e-08 -0.0986071293615759 -1.6325 0.7046418332892692 0.7046400744334272 -5.5802723705538834e-08 -0.098607549543734 -1.6326 0.7046425782483164 0.7046408197939085 -6.101280842097517e-08 -0.09860796960002573 -1.6327 0.7046433229276529 0.7046415649860958 -6.62172224045153e-08 -0.09860838953048828 -1.6328000000000003 0.7046440673274201 0.7046423100099799 -7.141477468414203e-08 -0.0986088093351588 -1.6329 0.7046448114477728 0.70464305486554 -7.660427620362342e-08 -0.09860922901407437 -1.633 0.7046455552888781 0.7046437995527424 -8.178454009421382e-08 -0.09860964856727228 -1.6331000000000002 0.7046462988509158 0.7046445440715396 -8.695438195177596e-08 -0.09861006799478952 -1.6332 0.7046470421340784 0.7046452884218728 -9.211262010175997e-08 -0.09861048729666327 -1.6333000000000002 0.7046477851385711 0.7046460326036696 -9.725807586721813e-08 -0.0986109064729306 -1.6334000000000002 0.7046485278646113 0.7046467766168459 -1.0238957385503428e-07 -0.09861132552362863 -1.6335 0.7046492703124293 0.7046475204613039 -1.0750594219878506e-07 -0.09861174444879438 -1.6336000000000002 0.7046500124822677 0.7046482641369344 -1.1260601283542837e-07 -0.098612163248465 -1.6337000000000002 0.7046507543743815 0.7046490076436149 -1.1768862179240003e-07 -0.09861258192267751 -1.6338000000000001 0.7046514959890384 0.7046497509812111 -1.2275260942266886e-07 -0.09861300047146898 -1.6339000000000001 0.704652237326518 0.7046504941495757 -1.277968206848945e-07 -0.09861341889487646 -1.634 0.7046529783871124 0.7046512371485497 -1.3282010540190126e-07 -0.09861383719293693 -1.6341 0.7046537191711261 0.7046519799779616 -1.3782131853476431e-07 -0.0986142553656875 -1.6342 0.7046544596788753 0.7046527226376271 -1.4279932042914056e-07 -0.0986146734131651 -1.6343 0.7046551999106887 0.7046534651273505 -1.4775297707547708e-07 -0.09861509133540668 -1.6344 0.7046559398669071 0.7046542074469241 -1.5268116037789325e-07 -0.09861550913244936 -1.6345 0.704656679547883 0.7046549495961274 -1.5758274840571573e-07 -0.09861592680433004 -1.6346 0.704657418953981 0.7046556915747287 -1.6245662565021746e-07 -0.09861634435108567 -1.6347 0.7046581580855775 0.7046564333824842 -1.6730168326921369e-07 -0.09861676177275329 -1.6348000000000003 0.7046588969430607 0.7046571750191379 -1.721168193455358e-07 -0.09861717906936973 -1.6349 0.7046596355268302 0.7046579164844224 -1.7690093915764815e-07 -0.09861759624097195 -1.635 0.7046603738372978 0.7046586577780587 -1.8165295537914128e-07 -0.09861801328759692 -1.6351000000000002 0.7046611118748866 0.7046593988997563 -1.8637178837710433e-07 -0.09861843020928157 -1.6352 0.7046618496400304 0.7046601398492127 -1.910563664289655e-07 -0.09861884700606267 -1.6353000000000002 0.7046625871331758 0.7046608806261148 -1.957056259757617e-07 -0.0986192636779773 -1.6354000000000002 0.7046633243547792 0.7046616212301375 -2.0031851186153027e-07 -0.09861968022506218 -1.6355 0.7046640613053092 0.7046623616609451 -2.048939775796399e-07 -0.09862009664735427 -1.6356000000000002 0.7046647979852452 0.7046631019181903 -2.094309854740184e-07 -0.09862051294489044 -1.6357000000000002 0.7046655343950772 0.7046638420015148 -2.139285070305863e-07 -0.09862092911770749 -1.6358000000000001 0.7046662705353064 0.7046645819105497 -2.1838552308889314e-07 -0.09862134516584226 -1.6359000000000001 0.704667006406445 0.704665321644915 -2.2280102402946755e-07 -0.09862176108933163 -1.636 0.7046677420090153 0.70466606120422 -2.2717401007912863e-07 -0.09862217688821234 -1.6361 0.7046684773435508 0.7046668005880639 -2.3150349148445826e-07 -0.09862259256252126 -1.6362 0.7046692124105949 0.7046675397960347 -2.3578848872690683e-07 -0.09862300811229519 -1.6363 0.7046699472107018 0.7046682788277102 -2.4002803279687956e-07 -0.09862342353757089 -1.6364 0.7046706817444355 0.704669017682658 -2.442211653810866e-07 -0.0986238388383851 -1.6365 0.7046714160123704 0.7046697563604362 -2.483669390672405e-07 -0.09862425401477466 -1.6366 0.7046721500150908 0.7046704948605917 -2.5246441756263116e-07 -0.09862466906677629 -1.6367 0.7046728837531906 0.7046712331826623 -2.5651267594392624e-07 -0.09862508399442672 -1.6368000000000003 0.7046736172272745 0.704671971326176 -2.6051080081329614e-07 -0.09862549879776275 -1.6369 0.7046743504379552 0.7046727092906504 -2.644578905239281e-07 -0.09862591347682101 -1.637 0.7046750833858559 0.7046734470755947 -2.6835305540900967e-07 -0.09862632803163823 -1.6371000000000002 0.7046758160716091 0.7046741846805076 -2.721954179413233e-07 -0.09862674246225113 -1.6372 0.7046765484958566 0.7046749221048794 -2.7598411295876035e-07 -0.09862715676869642 -1.6373000000000002 0.7046772806592487 0.7046756593481904 -2.797182878516713e-07 -0.09862757095101074 -1.6374000000000002 0.7046780125624452 0.7046763964099132 -2.8339710274674634e-07 -0.09862798500923078 -1.6375 0.7046787442061146 0.7046771332895102 -2.8701973069089615e-07 -0.0986283989433932 -1.6376000000000002 0.7046794755909342 0.7046778699864358 -2.9058535787676587e-07 -0.09862881275353463 -1.6377000000000002 0.7046802067175892 0.7046786065001356 -2.940931837606964e-07 -0.09862922643969171 -1.6378000000000001 0.7046809375867743 0.7046793428300473 -2.975424213055855e-07 -0.09862964000190115 -1.6379000000000001 0.7046816681991914 0.7046800789755993 -3.009322971439521e-07 -0.09863005344019944 -1.638 0.7046823985555509 0.7046808149362127 -3.042620516924277e-07 -0.09863046675462328 -1.6381000000000001 0.7046831286565715 0.7046815507113007 -3.0753093938074016e-07 -0.09863087994520929 -1.6382 0.7046838585029789 0.7046822863002677 -3.107382288425331e-07 -0.09863129301199396 -1.6383 0.704684588095507 0.7046830217025115 -3.138832029986327e-07 -0.09863170595501387 -1.6384 0.7046853174348974 0.7046837569174218 -3.169651592721534e-07 -0.09863211877430568 -1.6385 0.7046860465218983 0.7046844919443809 -3.199834097203369e-07 -0.09863253146990586 -1.6386 0.7046867753572654 0.7046852267827641 -3.2293728122884113e-07 -0.09863294404185098 -1.6387 0.7046875039417617 0.70468596143194 -3.2582611564357933e-07 -0.09863335649017758 -1.6388000000000003 0.7046882322761567 0.7046866958912694 -3.286492698470478e-07 -0.09863376881492217 -1.6389 0.7046889603612267 0.7046874301601076 -3.31406116015065e-07 -0.0986341810161213 -1.639 0.7046896881977542 0.7046881642378021 -3.3409604168616047e-07 -0.0986345930938114 -1.6391000000000002 0.7046904157865291 0.7046888981236947 -3.3671844989341393e-07 -0.09863500504802902 -1.6392 0.704691143128346 0.7046896318171212 -3.392727593795608e-07 -0.09863541687881064 -1.6393000000000002 0.7046918702240064 0.7046903653174104 -3.4175840460393125e-07 -0.09863582858619266 -1.6394000000000002 0.7046925970743176 0.7046910986238862 -3.4417483592980025e-07 -0.09863624017021162 -1.6395 0.7046933236800927 0.7046918317358665 -3.465215197492877e-07 -0.09863665163090397 -1.6396000000000002 0.7046940500421499 0.7046925646526632 -3.4879793864295294e-07 -0.09863706296830611 -1.6397 0.7046947761613127 0.7046932973735834 -3.5100359138673376e-07 -0.0986374741824545 -1.6398000000000001 0.7046955020384099 0.704694029897929 -3.531379931323575e-07 -0.09863788527338552 -1.6399000000000001 0.7046962276742755 0.7046947622249965 -3.552006755253023e-07 -0.09863829624113558 -1.64 0.7046969530697481 0.704695494354078 -3.5719118678806394e-07 -0.09863870708574111 -1.6401000000000001 0.704697678225671 0.7046962262844605 -3.591090917270945e-07 -0.0986391178072385 -1.6402 0.7046984031428916 0.7046969580154268 -3.6095397205199165e-07 -0.09863952840566412 -1.6403 0.7046991278222619 0.7046976895462554 -3.6272542627141524e-07 -0.0986399388810543 -1.6404 0.7046998522646382 0.7046984208762206 -3.6442306980410955e-07 -0.09864034923344542 -1.6405 0.7047005764708798 0.7046991520045929 -3.6604653513849783e-07 -0.09864075946287383 -1.6406 0.7047013004418508 0.7046998829306388 -3.6759547187431574e-07 -0.0986411695693759 -1.6407 0.704702024178418 0.7047006136536216 -3.690695467920002e-07 -0.09864157955298786 -1.6408000000000003 0.704702747681452 0.7047013441728012 -3.704684438735062e-07 -0.0986419894137461 -1.6409 0.7047034709518265 0.7047020744874335 -3.7179186446190116e-07 -0.09864239915168693 -1.641 0.7047041939904178 0.7047028045967725 -3.7303952735157075e-07 -0.09864280876684658 -1.6411000000000002 0.7047049167981054 0.704703534500069 -3.742111686771965e-07 -0.09864321825926137 -1.6412 0.7047056393757715 0.7047042641965708 -3.753065421358004e-07 -0.09864362762896761 -1.6413000000000002 0.7047063617243001 0.7047049936855236 -3.763254189520504e-07 -0.09864403687600153 -1.6414000000000002 0.7047070838445778 0.7047057229661707 -3.7726758798234394e-07 -0.09864444600039932 -1.6415 0.7047078057374935 0.7047064520377538 -3.7813285565929666e-07 -0.09864485500219733 -1.6416000000000002 0.7047085274039373 0.7047071808995121 -3.7892104613052036e-07 -0.09864526388143174 -1.6417 0.7047092488448012 0.7047079095506832 -3.796320013071952e-07 -0.09864567263813873 -1.6418000000000001 0.7047099700609791 0.7047086379905035 -3.8026558080855866e-07 -0.09864608127235455 -1.6419000000000001 0.7047106910533657 0.704709366218208 -3.808216620243554e-07 -0.09864648978411542 -1.642 0.7047114118228569 0.7047100942330303 -3.8130014016340974e-07 -0.09864689817345748 -1.6421000000000001 0.7047121323703494 0.7047108220342035 -3.8170092823974766e-07 -0.09864730644041693 -1.6422 0.7047128526967407 0.7047115496209597 -3.8202395707953585e-07 -0.09864771458502994 -1.6423 0.7047135728029288 0.7047122769925306 -3.822691753765928e-07 -0.09864812260733268 -1.6424 0.704714292689812 0.7047130041481473 -3.824365496993276e-07 -0.09864853050736128 -1.6425 0.7047150123582887 0.7047137310870413 -3.8252606444910686e-07 -0.09864893828515187 -1.6426 0.7047157318092575 0.7047144578084432 -3.825377218116821e-07 -0.09864934594074061 -1.6427 0.7047164510436162 0.7047151843115849 -3.824715419029068e-07 -0.0986497534741636 -1.6428000000000003 0.7047171700622625 0.7047159105956977 -3.8232756263689716e-07 -0.09865016088545692 -1.6429 0.7047178888660937 0.7047166366600139 -3.8210583977460466e-07 -0.09865056817465669 -1.643 0.7047186074560056 0.7047173625037675 -3.81806446847488e-07 -0.09865097534179904 -1.6431000000000002 0.7047193258328937 0.7047180881261921 -3.814294751852687e-07 -0.09865138238692 -1.6432 0.7047200439976515 0.7047188135265229 -3.8097503390205345e-07 -0.09865178931005562 -1.6433000000000002 0.7047207619511717 0.7047195387039968 -3.8044324975061716e-07 -0.09865219611124196 -1.6434000000000002 0.7047214796943456 0.704720263657852 -3.7983426728199765e-07 -0.09865260279051509 -1.6435 0.7047221972280621 0.7047209883873287 -3.79148248623451e-07 -0.09865300934791105 -1.6436000000000002 0.7047229145532081 0.7047217128916683 -3.783853735686571e-07 -0.09865341578346577 -1.6437 0.7047236316706691 0.7047224371701153 -3.7754583943894193e-07 -0.0986538220972154 -1.6438000000000001 0.7047243485813279 0.704723161221916 -3.766298610555219e-07 -0.09865422828919589 -1.6439000000000001 0.7047250652860644 0.704723885046319 -3.756376707464426e-07 -0.0986546343594432 -1.644 0.7047257817857558 0.7047246086425759 -3.7456951820086237e-07 -0.09865504030799331 -1.6441000000000001 0.7047264980812771 0.7047253320099413 -3.7342567048292974e-07 -0.0986554461348822 -1.6442 0.7047272141734997 0.7047260551476724 -3.7220641186525016e-07 -0.09865585184014591 -1.6443 0.7047279300632916 0.7047267780550299 -3.709120438982749e-07 -0.09865625742382028 -1.6444 0.7047286457515174 0.7047275007312779 -3.6954288524376766e-07 -0.09865666288594124 -1.6445 0.7047293612390384 0.704728223175684 -3.68099271570721e-07 -0.0986570682265448 -1.6446 0.7047300765267119 0.7047289453875198 -3.665815555622953e-07 -0.09865747344566686 -1.6447 0.7047307916153913 0.7047296673660608 -3.6499010674928556e-07 -0.09865787854334332 -1.6448000000000003 0.7047315065059256 0.7047303891105865 -3.6332531151012093e-07 -0.09865828351961009 -1.6449 0.7047322211991598 0.7047311106203804 -3.6158757286963716e-07 -0.09865868837450303 -1.645 0.7047329356959336 0.7047318318947315 -3.597773104713209e-07 -0.09865909310805808 -1.6451000000000002 0.7047336499970829 0.7047325529329326 -3.578949604940429e-07 -0.09865949772031105 -1.6452 0.7047343641034379 0.7047332737342813 -3.5594097547164694e-07 -0.09865990221129776 -1.6453000000000002 0.7047350780158246 0.7047339942980808 -3.539158242374385e-07 -0.09866030658105412 -1.6454000000000002 0.7047357917350632 0.7047347146236396 -3.518199917992848e-07 -0.09866071082961603 -1.6455 0.7047365052619685 0.7047354347102704 -3.496539792702258e-07 -0.09866111495701918 -1.6456000000000002 0.7047372185973498 0.7047361545572929 -3.474183036256129e-07 -0.09866151896329949 -1.6457 0.7047379317420108 0.7047368741640316 -3.4511349771004785e-07 -0.09866192284849269 -1.6458000000000002 0.7047386446967492 0.704737593529817 -3.42740110029216e-07 -0.09866232661263463 -1.6459000000000001 0.7047393574623564 0.704738312653986 -3.4029870470131396e-07 -0.09866273025576107 -1.646 0.704740070039618 0.7047390315358815 -3.377898612419439e-07 -0.09866313377790781 -1.6461000000000001 0.7047407824293129 0.7047397501748525 -3.352141744530912e-07 -0.0986635371791106 -1.6462 0.7047414946322133 0.704740468570255 -3.325722542912857e-07 -0.0986639404594052 -1.6463 0.7047422066490852 0.7047411867214513 -3.2986472568719005e-07 -0.0986643436188274 -1.6464 0.7047429184806866 0.7047419046278109 -3.27092228490089e-07 -0.09866474665741283 -1.6465 0.70474363012777 0.7047426222887101 -3.242554172250278e-07 -0.09866514957519729 -1.6466 0.7047443415910795 0.7047433397035323 -3.213549609540345e-07 -0.09866555237221647 -1.6467 0.7047450528713523 0.7047440568716683 -3.1839154315121965e-07 -0.09866595504850607 -1.6468000000000003 0.7047457639693182 0.7047447737925165 -3.1536586152930424e-07 -0.09866635760410185 -1.6469 0.7047464748856987 0.7047454904654827 -3.122786279008416e-07 -0.09866676003903936 -1.647 0.7047471856212086 0.7047462068899808 -3.0913056790066173e-07 -0.0986671623533544 -1.6471000000000002 0.7047478961765535 0.7047469230654322 -3.0592242093729904e-07 -0.09866756454708253 -1.6472 0.704748606552432 0.7047476389912666 -3.026549399848255e-07 -0.09866796662025949 -1.6473000000000002 0.7047493167495336 0.7047483546669221 -2.993288914197867e-07 -0.09866836857292088 -1.6474000000000002 0.7047500267685401 0.7047490700918446 -2.9594505478527933e-07 -0.09866877040510236 -1.6475 0.7047507366101244 0.7047497852654891 -2.925042226556429e-07 -0.09866917211683957 -1.6476000000000002 0.7047514462749507 0.7047505001873188 -2.8900720043523176e-07 -0.09866957370816806 -1.6477 0.7047521557636744 0.7047512148568054 -2.85454806195351e-07 -0.0986699751791234 -1.6478000000000002 0.7047528650769421 0.7047519292734306 -2.8184787046608983e-07 -0.09867037652974128 -1.6479000000000001 0.7047535742153914 0.7047526434366838 -2.781872359969295e-07 -0.09867077776005723 -1.648 0.7047542831796507 0.7047533573460645 -2.7447375763878235e-07 -0.09867117887010683 -1.6481000000000001 0.7047549919703391 0.7047540710010809 -2.707083020941914e-07 -0.09867157985992564 -1.6482 0.7047557005880656 0.7047547844012512 -2.668917477403887e-07 -0.09867198072954919 -1.6483 0.7047564090334307 0.7047554975461022 -2.630249844037813e-07 -0.09867238147901303 -1.6484 0.7047571173070246 0.7047562104351714 -2.5910891316913154e-07 -0.0986727821083527 -1.6485 0.7047578254094278 0.7047569230680055 -2.5514444614363474e-07 -0.09867318261760373 -1.6486 0.7047585333412107 0.7047576354441611 -2.5113250628344685e-07 -0.09867358300680162 -1.6487 0.7047592411029345 0.7047583475632048 -2.4707402716470095e-07 -0.09867398327598187 -1.6488000000000003 0.704759948695149 0.7047590594247131 -2.4296995274411537e-07 -0.09867438342517992 -1.6489 0.704760656118395 0.7047597710282734 -2.3882123714388803e-07 -0.09867478345443137 -1.649 0.7047613633732017 0.7047604823734828 -2.3462884449210186e-07 -0.09867518336377158 -1.6491000000000002 0.7047620704600885 0.7047611934599489 -2.3039374859659678e-07 -0.09867558315323605 -1.6492 0.7047627773795647 0.7047619042872899 -2.2611693279925293e-07 -0.09867598282286018 -1.6493000000000002 0.704763484132128 0.7047626148551349 -2.2179938971925162e-07 -0.09867638237267946 -1.6494000000000002 0.704764190718266 0.7047633251631231 -2.1744212100674454e-07 -0.09867678180272929 -1.6495 0.7047648971384555 0.7047640352109054 -2.130461371416259e-07 -0.09867718111304515 -1.6496000000000002 0.7047656033931615 0.7047647449981426 -2.0861245719414057e-07 -0.09867758030366236 -1.6497 0.7047663094828389 0.7047654545245071 -2.0414210855773662e-07 -0.09867797937461635 -1.6498000000000002 0.7047670154079311 0.7047661637896825 -1.9963612675824582e-07 -0.0986783783259425 -1.6499000000000001 0.7047677211688705 0.7047668727933631 -1.9509555515898058e-07 -0.09867877715767626 -1.65 0.704768426766078 0.7047675815352548 -1.9052144478032274e-07 -0.09867917586985292 -1.6501000000000001 0.7047691321999631 0.7047682900150744 -1.8591485401175945e-07 -0.09867957446250784 -1.6502000000000001 0.7047698374709239 0.7047689982325507 -1.8127684837943026e-07 -0.09867997293567639 -1.6503 0.7047705425793471 0.7047697061874236 -1.766085003171436e-07 -0.09868037128939389 -1.6504 0.7047712475256078 0.7047704138794444 -1.7191088887147377e-07 -0.09868076952369562 -1.6505 0.7047719523100695 0.7047711213083767 -1.6718509950226779e-07 -0.09868116763861698 -1.6506 0.7047726569330839 0.7047718284739952 -1.6243222382417155e-07 -0.09868156563419328 -1.6507 0.7047733613949909 0.7047725353760861 -1.5765335933080882e-07 -0.09868196351045977 -1.6508000000000003 0.7047740656961183 0.7047732420144478 -1.5284960916406298e-07 -0.09868236126745168 -1.6509 0.7047747698367828 0.7047739483888906 -1.4802208183825605e-07 -0.09868275890520437 -1.651 0.7047754738172882 0.7047746544992368 -1.4317189100422623e-07 -0.0986831564237531 -1.6511000000000002 0.7047761776379272 0.7047753603453205 -1.3830015518391525e-07 -0.09868355382313312 -1.6512 0.7047768812989796 0.7047760659269875 -1.3340799751709875e-07 -0.09868395110337964 -1.6513000000000002 0.7047775848007134 0.7047767712440962 -1.2849654549423883e-07 -0.09868434826452792 -1.6514000000000002 0.7047782881433851 0.7047774762965169 -1.2356693069801028e-07 -0.0986847453066132 -1.6515 0.704778991327238 0.704778181084132 -1.1862028855350037e-07 -0.09868514222967072 -1.6516000000000002 0.704779694352504 0.7047788856068362 -1.1365775805238787e-07 -0.09868553903373566 -1.6517 0.7047803972194019 0.7047795898645359 -1.086804815100817e-07 -0.09868593571884314 -1.6518000000000002 0.7047810999281391 0.7047802938571508 -1.0368960427949159e-07 -0.09868633228502843 -1.6519000000000001 0.70478180247891 0.7047809975846115 -9.868627450122791e-08 -0.09868672873232665 -1.652 0.704782504871897 0.7047817010468621 -9.367164283818896e-08 -0.09868712506077298 -1.6521000000000001 0.7047832071072704 0.7047824042438585 -8.864686220841356e-08 -0.09868752127040259 -1.6522000000000001 0.7047839091851874 0.704783107175569 -8.361308751966834e-08 -0.09868791736125063 -1.6523 0.7047846111057934 0.7047838098419744 -7.857147541704551e-08 -0.09868831333335219 -1.6524 0.7047853128692214 0.7047845122430677 -7.352318399326402e-08 -0.09868870918674245 -1.6525 0.7047860144755913 0.7047852143788544 -6.846937254450722e-08 -0.0986891049214565 -1.6526 0.704786715925011 0.7047859162493525 -6.341120128853031e-08 -0.09868950053752942 -1.6527 0.7047874172175761 0.7047866178545923 -5.83498311118244e-08 -0.09868989603499632 -1.6528000000000003 0.7047881183533699 0.7047873191946165 -5.328642329271126e-08 -0.09869029141389238 -1.6529 0.7047888193324624 0.70478802026948 -4.8222139243303194e-08 -0.09869068667425251 -1.653 0.7047895201549119 0.7047887210792505 -4.3158140234928876e-08 -0.09869108181611183 -1.6531000000000002 0.704790220820764 0.704789421624008 -3.8095587139171626e-08 -0.09869147683950547 -1.6532 0.7047909213300517 0.7047901219038452 -3.303564015681888e-08 -0.09869187174446833 -1.6533000000000002 0.7047916216827961 0.7047908219188663 -2.7979458555160014e-08 -0.09869226653103555 -1.6534 0.7047923218790054 0.7047915216691889 -2.2928200400351012e-08 -0.09869266119924215 -1.6535 0.7047930219186753 0.7047922211549421 -1.7883022296067558e-08 -0.09869305574912308 -1.6536000000000002 0.7047937218017896 0.704792920376268 -1.2845079110177654e-08 -0.09869345018071338 -1.6537 0.7047944215283194 0.7047936193333209 -7.815523722989881e-09 -0.09869384449404804 -1.6538000000000002 0.7047951210982236 0.7047943180262668 -2.795506751432364e-09 -0.09869423868916201 -1.6539000000000001 0.7047958205114488 0.7047950164552851 2.2138237024821317e-09 -0.0986946327660903 -1.654 0.7047965197679292 0.7047957146205666 7.211322324875147e-09 -0.09869502672486792 -1.6541000000000001 0.7047972188675868 0.7047964125223141 1.2195846848042646e-08 -0.09869542056552973 -1.6542000000000001 0.7047979178103316 0.7047971101607434 1.7166258311530902e-08 -0.09869581428811075 -1.6543 0.7047986165960609 0.7047978075360819 2.2121421318875567e-08 -0.09869620789264583 -1.6544 0.7047993152246605 0.7047985046485692 2.7060204296075474e-08 -0.09869660137916993 -1.6545 0.704800013696004 0.704799201498457 3.198147975960741e-08 -0.098696994747718 -1.6546 0.7048007120099521 0.7047998980860088 3.6884124565358944e-08 -0.09869738799832488 -1.6547 0.7048014101663549 0.7048005944115006 4.1767020165367486e-08 -0.09869778113102552 -1.6548000000000003 0.7048021081650495 0.7048012904752194 4.662905286889618e-08 -0.09869817414585477 -1.6549 0.7048028060058615 0.704801986277465 5.1469114083560474e-08 -0.09869856704284748 -1.655 0.704803503688605 0.7048026818185482 5.628610058421024e-08 -0.09869895982203856 -1.6551000000000002 0.7048042012130815 0.7048033770987918 6.10789147575258e-08 -0.09869935248346279 -1.6552 0.7048048985790817 0.7048040721185308 6.584646484140977e-08 -0.09869974502715512 -1.6553000000000002 0.7048055957863839 0.704804766878111 7.058766519560389e-08 -0.09870013745315027 -1.6554 0.7048062928347553 0.7048054613778902 7.530143652373367e-08 -0.09870052976148312 -1.6555 0.7048069897239515 0.7048061556182377 7.99867061421905e-08 -0.09870092195218849 -1.6556000000000002 0.7048076864537167 0.7048068495995337 8.464240821431934e-08 -0.09870131402530116 -1.6557 0.7048083830237839 0.7048075433221702 8.926748398807582e-08 -0.09870170598085594 -1.6558000000000002 0.7048090794338742 0.70480823678655 9.386088203888754e-08 -0.09870209781888756 -1.6559000000000001 0.7048097756836986 0.7048089299930878 9.842155850384171e-08 -0.0987024895394309 -1.656 0.7048104717729557 0.7048096229422083 1.0294847735056734e-07 -0.09870288114252057 -1.6561000000000001 0.7048111677013346 0.7048103156343479 1.0744061055417697e-07 -0.09870327262819147 -1.6562000000000001 0.7048118634685119 0.704811008069954 1.1189693839563919e-07 -0.09870366399647824 -1.6563 0.7048125590741542 0.7048117002494844 1.163164496352509e-07 -0.09870405524741566 -1.6564 0.7048132545179173 0.7048123921734075 1.2069814178325422e-07 -0.0987044463810384 -1.6565 0.7048139497994466 0.7048130838422029 1.2504102131147277e-07 -0.09870483739738123 -1.6566 0.7048146449183763 0.7048137752563604 1.2934410386841733e-07 -0.09870522829647888 -1.6567 0.7048153398743308 0.7048144664163797 1.3360641452908606e-07 -0.09870561907836592 -1.6568000000000003 0.7048160346669239 0.7048151573227718 1.3782698799619242e-07 -0.0987060097430772 -1.6569 0.7048167292957587 0.7048158479760569 1.4200486882220975e-07 -0.09870640029064721 -1.657 0.704817423760429 0.7048165383767662 1.4613911160019089e-07 -0.09870679072111076 -1.6571000000000002 0.704818118060518 0.7048172285254402 1.5022878124479333e-07 -0.0987071810345024 -1.6572 0.7048188121955993 0.7048179184226293 1.542729531275877e-07 -0.09870757123085681 -1.6573000000000002 0.7048195061652365 0.7048186080688941 1.5827071335114407e-07 -0.09870796131020859 -1.6574 0.704820199968984 0.7048192974648048 1.6222115889474864e-07 -0.09870835127259248 -1.6575 0.7048208936063858 0.7048199866109404 1.661233978607346e-07 -0.0987087411180429 -1.6576000000000002 0.7048215870769774 0.7048206755078903 1.6997654966877107e-07 -0.09870913084659463 -1.6577 0.7048222803802842 0.7048213641562523 1.7377974524668272e-07 -0.09870952045828217 -1.6578000000000002 0.7048229735158227 0.7048220525566341 1.7753212722820821e-07 -0.09870990995314011 -1.6579000000000002 0.7048236664831005 0.7048227407096519 1.8123285014381985e-07 -0.09871029933120301 -1.658 0.7048243592816164 0.704823428615931 1.8488108062542086e-07 -0.09871068859250548 -1.6581000000000001 0.7048250519108596 0.7048241162761051 1.8847599756594002e-07 -0.09871107773708204 -1.6582000000000001 0.7048257443703121 0.7048248036908175 1.920167923448457e-07 -0.09871146676496732 -1.6583 0.7048264366594458 0.7048254908607183 1.9550266893569868e-07 -0.09871185567619567 -1.6584 0.7048271287777252 0.7048261777864678 1.989328441802385e-07 -0.09871224447080175 -1.6585 0.7048278207246061 0.7048268644687333 2.023065479132835e-07 -0.09871263314882003 -1.6586 0.7048285124995364 0.7048275509081907 2.0562302315355052e-07 -0.09871302171028502 -1.6587 0.704829204101956 0.7048282371055236 2.0888152622855483e-07 -0.09871341015523119 -1.6588000000000003 0.704829895531297 0.7048289230614233 2.1208132699665483e-07 -0.09871379848369305 -1.6589 0.7048305867869837 0.7048296087765892 2.152217089684827e-07 -0.09871418669570507 -1.659 0.7048312778684334 0.7048302942517275 2.1830196950123337e-07 -0.09871457479130169 -1.6591000000000002 0.7048319687750553 0.7048309794875525 2.2132141993397303e-07 -0.09871496277051743 -1.6592 0.7048326595062515 0.704831664484785 2.2427938576458084e-07 -0.09871535063338666 -1.6593000000000002 0.7048333500614177 0.7048323492441532 2.2717520677811853e-07 -0.09871573837994387 -1.6594 0.7048340404399419 0.7048330337663921 2.3000823720642494e-07 -0.09871612601022342 -1.6595 0.7048347306412055 0.7048337180522434 2.327778458391383e-07 -0.09871651352425974 -1.6596000000000002 0.7048354206645836 0.7048344021024555 2.354834162110464e-07 -0.09871690092208726 -1.6597 0.7048361105094447 0.704835085917783 2.3812434670617e-07 -0.09871728820374033 -1.6598000000000002 0.704836800175151 0.7048357694989871 2.407000507451129e-07 -0.09871767536925341 -1.6599000000000002 0.7048374896610587 0.704836452846834 2.4320995682669544e-07 -0.09871806241866074 -1.66 0.7048381789665179 0.7048371359620975 2.4565350870142666e-07 -0.0987184493519968 -1.6601000000000001 0.7048388680908731 0.7048378188455562 2.480301655449768e-07 -0.09871883616929594 -1.6602000000000001 0.704839557033463 0.7048385014979937 2.5033940198593285e-07 -0.09871922287059244 -1.6603 0.7048402457936209 0.7048391839202004 2.525807082931486e-07 -0.09871960945592073 -1.6604 0.7048409343706747 0.704839866112971 2.547535904104392e-07 -0.09871999592531505 -1.6605 0.7048416227639476 0.7048405480771054 2.5685757018556465e-07 -0.09872038227880975 -1.6606 0.7048423109727573 0.7048412298134086 2.5889218534941305e-07 -0.09872076851643911 -1.6607 0.7048429989964168 0.70484191132269 2.60856989689473e-07 -0.09872115463823739 -1.6608000000000003 0.7048436868342348 0.7048425926057644 2.627515531400393e-07 -0.09872154064423895 -1.6609 0.7048443744855157 0.70484327366345 2.6457546184466274e-07 -0.09872192653447803 -1.661 0.7048450619495592 0.7048439544965699 2.663283182879894e-07 -0.09872231230898891 -1.6611000000000002 0.7048457492256611 0.7048446351059509 2.6800974133045496e-07 -0.09872269796780583 -1.6612 0.7048464363131133 0.7048453154924235 2.696193663401236e-07 -0.09872308351096303 -1.6613000000000002 0.7048471232112044 0.7048459956568223 2.7115684529677164e-07 -0.09872346893849476 -1.6614 0.7048478099192186 0.7048466755999854 2.72621846743315e-07 -0.09872385425043528 -1.6615 0.7048484964364372 0.7048473553227536 2.740140560286708e-07 -0.09872423944681871 -1.6616000000000002 0.7048491827621386 0.7048480348259716 2.753331751967347e-07 -0.09872462452767934 -1.6617 0.7048498688955976 0.7048487141104869 2.7657892319454813e-07 -0.09872500949305132 -1.6618000000000002 0.7048505548360866 0.7048493931771496 2.777510358445423e-07 -0.09872539434296884 -1.6619000000000002 0.7048512405828753 0.7048500720268124 2.788492659624997e-07 -0.0987257790774661 -1.662 0.7048519261352308 0.7048507506603303 2.7987338335061507e-07 -0.09872616369657722 -1.6621000000000001 0.7048526114924181 0.704851429078561 2.8082317486688435e-07 -0.0987265482003364 -1.6622000000000001 0.7048532966537 0.7048521072823641 2.8169844450143255e-07 -0.09872693258877782 -1.6623 0.7048539816183373 0.7048527852726008 2.8249901336957484e-07 -0.09872731686193555 -1.6624 0.7048546663855892 0.704853463050134 2.8322471977426655e-07 -0.09872770101984371 -1.6625 0.7048553509547135 0.7048541406158285 2.8387541921304216e-07 -0.09872808506253647 -1.6626 0.7048560353249664 0.7048548179705502 2.8445098444046524e-07 -0.09872846899004793 -1.6627 0.7048567194956028 0.704855495115166 2.849513054889452e-07 -0.09872885280241217 -1.6628000000000003 0.7048574034658771 0.7048561720505437 2.853762896826151e-07 -0.09872923649966325 -1.6629 0.7048580872350425 0.7048568487775524 2.85725861602637e-07 -0.09872962008183529 -1.663 0.7048587708023519 0.704857525297061 2.8599996317046905e-07 -0.09873000354896237 -1.6631000000000002 0.704859454167057 0.7048582016099394 2.861985536201095e-07 -0.09873038690107842 -1.6632 0.7048601373284105 0.7048588777170577 2.863216095397303e-07 -0.09873077013821767 -1.6633000000000002 0.7048608202856641 0.7048595536192857 2.8636912483004373e-07 -0.09873115326041404 -1.6634 0.7048615030380697 0.7048602293174928 2.8634111069736345e-07 -0.09873153626770159 -1.6635 0.7048621855848802 0.7048609048125491 2.86237595688299e-07 -0.09873191916011438 -1.6636000000000002 0.7048628679253481 0.7048615801053233 2.8605862564812234e-07 -0.09873230193768638 -1.6637 0.704863550058727 0.7048622551966832 2.858042636860736e-07 -0.09873268460045156 -1.6638000000000002 0.7048642319842717 0.7048629300874962 2.854745902100553e-07 -0.09873306714844396 -1.6639000000000002 0.7048649137012377 0.704863604778629 2.850697028849991e-07 -0.09873344958169757 -1.664 0.7048655952088815 0.704864279270946 2.845897165495992e-07 -0.09873383190024633 -1.6641000000000001 0.7048662765064613 0.7048649535653106 2.840347632648843e-07 -0.09873421410412418 -1.6642000000000001 0.7048669575932367 0.7048656276625849 2.8340499223095117e-07 -0.0987345961933651 -1.6643000000000001 0.7048676384684698 0.7048663015636286 2.8270056978002556e-07 -0.09873497816800303 -1.6644 0.7048683191314237 0.7048669752693 2.819216792723789e-07 -0.09873536002807187 -1.6645 0.7048689995813642 0.7048676487804547 2.8106852113796155e-07 -0.09873574177360556 -1.6646 0.7048696798175589 0.7048683220979461 2.801413127515029e-07 -0.09873612340463798 -1.6647 0.7048703598392794 0.7048689952226252 2.791402883978167e-07 -0.09873650492120313 -1.6648000000000003 0.7048710396457982 0.7048696681553401 2.7806569924404556e-07 -0.09873688632333483 -1.6649 0.7048717192363912 0.7048703408969361 2.769178132494554e-07 -0.09873726761106692 -1.665 0.704872398610338 0.7048710134482552 2.7569691508910754e-07 -0.09873764878443335 -1.6651000000000002 0.7048730777669212 0.7048716858101365 2.7440330607753083e-07 -0.09873802984346797 -1.6652 0.704873756705426 0.7048723579834151 2.7303730417566063e-07 -0.09873841078820461 -1.6653000000000002 0.7048744354251422 0.704873029968923 2.7159924381042755e-07 -0.0987387916186771 -1.6654 0.7048751139253627 0.7048737017674883 2.7008947583312404e-07 -0.09873917233491931 -1.6655 0.7048757922053847 0.7048743733799347 2.685083674638933e-07 -0.09873955293696497 -1.6656000000000002 0.7048764702645096 0.7048750448070827 2.668563021529513e-07 -0.09873993342484809 -1.6657 0.7048771481020426 0.7048757160497475 2.6513367950425915e-07 -0.0987403137986023 -1.6658000000000002 0.7048778257172938 0.70487638710874 2.633409152061339e-07 -0.09874069405826144 -1.6659000000000002 0.7048785031095777 0.7048770579848669 2.6147844090634864e-07 -0.0987410742038593 -1.666 0.7048791802782138 0.7048777286789294 2.5954670408029346e-07 -0.09874145423542964 -1.6661000000000001 0.7048798572225264 0.7048783991917242 2.575461680170976e-07 -0.09874183415300622 -1.6662000000000001 0.7048805339418451 0.7048790695240432 2.554773116114628e-07 -0.09874221395662287 -1.6663000000000001 0.7048812104355044 0.7048797396766722 2.533406292595797e-07 -0.09874259364631327 -1.6664 0.7048818867028445 0.7048804096503916 2.511366308244334e-07 -0.09874297322211113 -1.6665 0.7048825627432115 0.7048810794459761 2.488658414068201e-07 -0.09874335268405021 -1.6666 0.7048832385559567 0.7048817490641952 2.465288012898359e-07 -0.09874373203216419 -1.6667 0.7048839141404385 0.7048824185058121 2.4412606581397656e-07 -0.09874411126648691 -1.6668000000000003 0.7048845894960198 0.7048830877715835 2.4165820518978753e-07 -0.09874449038705191 -1.6669 0.7048852646220709 0.7048837568622599 2.391258044145972e-07 -0.0987448693938929 -1.667 0.7048859395179683 0.7048844257785856 2.3652946310598333e-07 -0.09874524828704362 -1.6671 0.7048866141830947 0.7048850945212983 2.3386979539075092e-07 -0.0987456270665377 -1.6672 0.70488728861684 0.7048857630911289 2.3114742968982638e-07 -0.09874600573240877 -1.6673000000000002 0.7048879628186009 0.7048864314888013 2.2836300868356307e-07 -0.0987463842846906 -1.6674 0.7048886367877811 0.7048870997150322 2.255171890550023e-07 -0.09874676272341674 -1.6675 0.7048893105237912 0.7048877677705312 2.2261064139966757e-07 -0.09874714104862081 -1.6676000000000002 0.7048899840260495 0.7048884356560005 2.1964405000352016e-07 -0.09874751926033648 -1.6677 0.7048906572939815 0.7048891033721347 2.1661811276663112e-07 -0.09874789735859728 -1.6678000000000002 0.7048913303270204 0.7048897709196211 2.1353354096032007e-07 -0.09874827534343684 -1.6679000000000002 0.7048920031246073 0.7048904382991387 2.1039105912654121e-07 -0.09874865321488874 -1.668 0.7048926756861912 0.7048911055113589 2.071914048662471e-07 -0.09874903097298658 -1.6681000000000001 0.7048933480112289 0.7048917725569452 2.0393532866938568e-07 -0.09874940861776393 -1.6682000000000001 0.704894020099186 0.7048924394365528 2.0062359374489747e-07 -0.09874978614925442 -1.6683000000000001 0.7048946919495356 0.7048931061508279 1.9725697585765145e-07 -0.09875016356749153 -1.6684 0.7048953635617592 0.7048937727004092 1.9383626310987e-07 -0.09875054087250879 -1.6685 0.7048960349353477 0.7048944390859259 1.903622557954121e-07 -0.09875091806433973 -1.6686 0.7048967060698 0.7048951053079991 1.8683576620548425e-07 -0.09875129514301792 -1.6687 0.7048973769646244 0.7048957713672408 1.8325761841006538e-07 -0.09875167210857683 -1.6688000000000003 0.7048980476193375 0.7048964372642541 1.796286481017817e-07 -0.09875204896104994 -1.6689 0.7048987180334654 0.7048971029996329 1.75949702380801e-07 -0.09875242570047081 -1.669 0.7048993882065433 0.7048977685739619 1.722216395397269e-07 -0.09875280232687288 -1.6691 0.7049000581381155 0.7048984339878163 1.6844532891788222e-07 -0.09875317884028958 -1.6692 0.7049007278277364 0.7048990992417625 1.6462165065844747e-07 -0.09875355524075452 -1.6693000000000002 0.7049013972749691 0.7048997643363565 1.60751495514172e-07 -0.09875393152830106 -1.6694 0.7049020664793867 0.704900429272145 1.568357646079821e-07 -0.09875430770296262 -1.6695 0.7049027354405719 0.704901094049665 1.5287536926644751e-07 -0.09875468376477269 -1.6696000000000002 0.7049034041581178 0.7049017586694433 1.4887123080814524e-07 -0.09875505971376464 -1.6697 0.7049040726316268 0.7049024231319969 1.4482428032161487e-07 -0.09875543554997193 -1.6698000000000002 0.7049047408607118 0.7049030874378328 1.4073545840861956e-07 -0.09875581127342797 -1.6699000000000002 0.7049054088449955 0.7049037515874474 1.3660571502108199e-07 -0.0987561868841661 -1.67 0.7049060765841113 0.7049044155813272 1.3243600922516197e-07 -0.09875656238221975 -1.6701000000000001 0.7049067440777027 0.7049050794199483 1.2822730896186463e-07 -0.0987569377676223 -1.6702000000000001 0.7049074113254239 0.704905743103776 1.2398059082846524e-07 -0.09875731304040714 -1.6703000000000001 0.704908078326939 0.7049064066332651 1.1969683985646462e-07 -0.09875768820060755 -1.6704 0.7049087450819237 0.7049070700088598 1.153770492964834e-07 -0.09875806324825695 -1.6705 0.7049094115900634 0.7049077332309939 1.1102222036846188e-07 -0.09875843818338863 -1.6706 0.7049100778510551 0.70490839630009 1.0663336203614593e-07 -0.09875881300603596 -1.6707 0.7049107438646064 0.7049090592165592 1.0221149077116465e-07 -0.09875918771623224 -1.6708000000000003 0.7049114096304356 0.7049097219808032 9.775763032404683e-08 -0.0987595623140108 -1.6709 0.7049120751482725 0.704910384593211 9.327281148135969e-08 -0.09875993679940491 -1.671 0.7049127404178578 0.7049110470541613 8.875807181590867e-08 -0.09876031117244789 -1.6711 0.7049134054389432 0.7049117093640214 8.421445549244844e-08 -0.098760685433173 -1.6712 0.7049140702112918 0.7049123715231473 7.964301296237153e-08 -0.09876105958161352 -1.6713000000000002 0.704914734734678 0.7049130335318838 7.504480077115405e-08 -0.0987614336178027 -1.6714 0.7049153990088879 0.7049136953905641 7.042088129120827e-08 -0.09876180754177383 -1.6715 0.7049160630337182 0.70491435709951 6.577232247555187e-08 -0.09876218135356009 -1.6716000000000002 0.7049167268089778 0.7049150186590322 6.110019762535501e-08 -0.0987625550531948 -1.6717 0.7049173903344871 0.7049156800694288 5.640558513146654e-08 -0.09876292864071112 -1.6718000000000002 0.7049180536100775 0.7049163413309875 5.168956821940962e-08 -0.09876330211614227 -1.6719000000000002 0.7049187166355928 0.7049170024439831 4.695323471866353e-08 -0.09876367547952147 -1.672 0.7049193794108879 0.70491766340868 4.219767679725095e-08 -0.0987640487308819 -1.6721000000000001 0.7049200419358299 0.7049183242253296 3.742399072408087e-08 -0.09876442187025677 -1.6722000000000001 0.7049207042102973 0.7049189848941724 3.263327658098447e-08 -0.09876479489767924 -1.6723000000000001 0.7049213662341804 0.7049196454154366 2.782663805628305e-08 -0.09876516781318248 -1.6724 0.7049220280073818 0.7049203057893384 2.3005182165497517e-08 -0.09876554061679962 -1.6725 0.7049226895298153 0.7049209660160827 1.8170018997211435e-08 -0.09876591330856385 -1.6726 0.7049233508014072 0.7049216260958618 1.3322261458066642e-08 -0.09876628588850828 -1.6727 0.7049240118220957 0.7049222860288564 8.463025020361004e-09 -0.09876665835666605 -1.6728000000000003 0.7049246725918304 0.7049229458152351 3.5934274679114142e-09 -0.09876703071307026 -1.6729 0.7049253331105737 0.7049236054551546 -1.2854113710936144e-09 -0.09876740295775413 -1.673 0.704925993378299 0.7049242649487595 -6.172369872159411e-09 -0.09876777509075062 -1.6731 0.7049266533949925 0.7049249242961819 -1.1066324872091582e-08 -0.09876814711209285 -1.6732 0.7049273131606522 0.7049255834975428 -1.5966151934842382e-08 -0.0987685190218139 -1.6733000000000002 0.704927972675288 0.7049262425529501 -2.0870725604346663e-08 -0.0987688908199469 -1.6734 0.7049286319389219 0.7049269014625001 -2.5778919661694627e-08 -0.09876926250652479 -1.6735 0.7049292909515881 0.7049275602262773 -3.068960739054452e-08 -0.09876963408158068 -1.6736000000000002 0.7049299497133328 0.7049282188443537 -3.560166182583861e-08 -0.09877000554514763 -1.6737 0.7049306082242142 0.7049288773167894 -4.051395601954114e-08 -0.09877037689725865 -1.6738000000000002 0.7049312664843024 0.7049295356436325 -4.542536329713346e-08 -0.09877074813794683 -1.6739000000000002 0.7049319244936803 0.7049301938249188 -5.0334757514597026e-08 -0.09877111926724513 -1.674 0.7049325822524416 0.7049308518606721 -5.524101331965195e-08 -0.0987714902851866 -1.6741000000000001 0.7049332397606931 0.704931509750904 -6.014300640497239e-08 -0.09877186119180417 -1.6742000000000001 0.704933897018553 0.7049321674956144 -6.503961377324688e-08 -0.09877223198713088 -1.6743000000000001 0.7049345540261516 0.7049328250947908 -6.992971398559616e-08 -0.09877260267119965 -1.6744 0.7049352107836311 0.7049334825484089 -7.481218741983015e-08 -0.09877297324404344 -1.6745 0.7049358672911459 0.7049341398564324 -7.968591653889634e-08 -0.09877334370569521 -1.6746 0.7049365235488625 0.7049347970188133 -8.45497861263686e-08 -0.098773714056188 -1.6747 0.7049371795569588 0.7049354540354912 -8.940268355663028e-08 -0.09877408429555462 -1.6748000000000003 0.7049378353156248 0.7049361109063939 -9.424349904293972e-08 -0.09877445442382812 -1.6749 0.7049384908250624 0.7049367676314378 -9.907112589677136e-08 -0.09877482444104138 -1.675 0.7049391460854849 0.7049374242105266 -1.0388446077327917e-07 -0.09877519434722723 -1.6751 0.704939801097118 0.7049380806435532 -1.0868240393150513e-07 -0.09877556414241867 -1.6752 0.7049404558601984 0.7049387369303981 -1.1346385947810789e-07 -0.0987759338266485 -1.6753000000000002 0.704941110374975 0.7049393930709301 -1.1822773561542821e-07 -0.09877630339994964 -1.6754 0.7049417646417082 0.7049400490650068 -1.229729449069017e-07 -0.09877667286235499 -1.6755 0.7049424186606699 0.7049407049124736 -1.2769840450344017e-07 -0.09877704221389737 -1.6756000000000002 0.7049430724321437 0.7049413606131649 -1.3240303640971174e-07 -0.09877741145460966 -1.6757 0.7049437259564246 0.7049420161669031 -1.3708576772179792e-07 -0.09877778058452472 -1.6758000000000002 0.7049443792338188 0.7049426715734997 -1.4174553085964658e-07 -0.09877814960367534 -1.6759000000000002 0.7049450322646437 0.704943326832754 -1.4638126383595407e-07 -0.09877851851209432 -1.676 0.7049456850492285 0.7049439819444548 -1.5099191047474037e-07 -0.09877888730981449 -1.6761000000000001 0.7049463375879136 0.7049446369083796 -1.5557642067155764e-07 -0.09877925599686871 -1.6762000000000001 0.7049469898810501 0.7049452917242942 -1.601337506155348e-07 -0.09877962457328975 -1.6763000000000001 0.7049476419290004 0.7049459463919538 -1.646628630339736e-07 -0.09877999303911039 -1.6764000000000001 0.7049482937321383 0.7049466009111018 -1.6916272742480143e-07 -0.09878036139436341 -1.6765 0.7049489452908475 0.7049472552814714 -1.7363232030637166e-07 -0.09878072963908154 -1.6766 0.7049495966055238 0.7049479095027846 -1.7807062542563035e-07 -0.09878109777329756 -1.6767 0.704950247676573 0.7049485635747528 -1.8247663402179426e-07 -0.09878146579704422 -1.6768000000000003 0.7049508985044117 0.7049492174970762 -1.8684934500329264e-07 -0.09878183371035426 -1.6769 0.7049515490894677 0.7049498712694449 -1.9118776523746606e-07 -0.09878220151326045 -1.677 0.7049521994321782 0.7049505248915378 -1.954909097309776e-07 -0.09878256920579542 -1.6771 0.7049528495329919 0.7049511783630239 -1.9975780187614367e-07 -0.09878293678799194 -1.6772 0.7049534993923672 0.7049518316835619 -2.039874736556313e-07 -0.09878330425988271 -1.6773000000000002 0.704954149010773 0.7049524848527997 -2.0817896588878892e-07 -0.09878367162150042 -1.6774 0.7049547983886886 0.7049531378703757 -2.1233132840858815e-07 -0.09878403887287779 -1.6775 0.7049554475266024 0.7049537907359172 -2.164436203079545e-07 -0.09878440601404737 -1.6776000000000002 0.7049560964250138 0.7049544434490426 -2.2051491015140368e-07 -0.09878477304504191 -1.6777 0.7049567450844314 0.7049550960093598 -2.2454427618320838e-07 -0.09878513996589405 -1.6778000000000002 0.7049573935053741 0.7049557484164671 -2.2853080650780955e-07 -0.09878550677663644 -1.6779000000000002 0.7049580416883696 0.7049564006699529 -2.3247359934655543e-07 -0.0987858734773017 -1.678 0.7049586896339561 0.7049570527693967 -2.3637176321811282e-07 -0.09878624006792244 -1.6781000000000001 0.7049593373426803 0.7049577047143678 -2.4022441711540887e-07 -0.0987866065485313 -1.6782000000000001 0.7049599848150989 0.7049583565044271 -2.4403069074502293e-07 -0.09878697291916093 -1.6783000000000001 0.7049606320517774 0.7049590081391248 -2.4778972467984217e-07 -0.09878733917984384 -1.6784000000000001 0.7049612790532904 0.7049596596180033 -2.515006706053924e-07 -0.09878770533061265 -1.6785 0.7049619258202213 0.704960310940596 -2.551626914724936e-07 -0.09878807137149995 -1.6786 0.7049625723531628 0.7049609621064268 -2.5877496171583525e-07 -0.09878843730253833 -1.6787 0.7049632186527156 0.7049616131150112 -2.623366674031624e-07 -0.0987888031237603 -1.6788000000000003 0.7049638647194896 0.704962263965856 -2.658470064191565e-07 -0.09878916883519842 -1.6789 0.7049645105541026 0.70496291465846 -2.693051887117659e-07 -0.09878953443688528 -1.679 0.7049651561571811 0.704963565192313 -2.727104363858812e-07 -0.09878989992885338 -1.6791 0.7049658015293594 0.7049642155668969 -2.760619839149714e-07 -0.0987902653111352 -1.6792 0.7049664466712803 0.7049648657816857 -2.793590783457811e-07 -0.09879063058376329 -1.6793000000000002 0.7049670915835939 0.7049655158361454 -2.8260097940241424e-07 -0.09879099574677014 -1.6794 0.7049677362669586 0.7049661657297339 -2.8578695968756174e-07 -0.09879136080018829 -1.6795 0.7049683807220402 0.7049668154619015 -2.8891630484556563e-07 -0.0987917257440501 -1.6796000000000002 0.704969024949512 0.7049674650320916 -2.9198831374629974e-07 -0.09879209057838823 -1.6797 0.7049696689500546 0.7049681144397397 -2.950022985892531e-07 -0.09879245530323502 -1.6798000000000002 0.7049703127243554 0.7049687636842741 -2.9795758506659387e-07 -0.09879281991862293 -1.6799000000000002 0.7049709562731097 0.7049694127651162 -3.008535125713363e-07 -0.09879318442458446 -1.68 0.7049715995970187 0.7049700616816803 -3.0368943428754624e-07 -0.09879354882115199 -1.6801000000000001 0.7049722426967913 0.7049707104333739 -3.064647173534052e-07 -0.09879391310835794 -1.6802000000000001 0.7049728855731423 0.7049713590195983 -3.091787429826409e-07 -0.0987942772862348 -1.6803000000000001 0.7049735282267935 0.7049720074397476 -3.1183090663799984e-07 -0.09879464135481493 -1.6804000000000001 0.7049741706584722 0.7049726556932105 -3.1442061814573874e-07 -0.09879500531413073 -1.6805 0.7049748128689128 0.7049733037793688 -3.169473018205249e-07 -0.09879536916421462 -1.6806 0.7049754548588547 0.7049739516975984 -3.1941039662503057e-07 -0.09879573290509891 -1.6807 0.7049760966290439 0.7049745994472695 -3.2180935623238316e-07 -0.09879609653681608 -1.6808 0.7049767381802314 0.7049752470277466 -3.241436492343319e-07 -0.09879646005939836 -1.6809 0.7049773795131745 0.7049758944383888 -3.2641275918982027e-07 -0.09879682347287824 -1.681 0.7049780206286351 0.7049765416785497 -3.2861618474294696e-07 -0.09879718677728795 -1.6811 0.7049786615273805 0.7049771887475778 -3.307534397686829e-07 -0.09879754997265992 -1.6812 0.7049793022101829 0.7049778356448162 -3.3282405345613775e-07 -0.09879791305902641 -1.6813000000000002 0.7049799426778197 0.7049784823696035 -3.3482757041958244e-07 -0.09879827603641973 -1.6814 0.7049805829310726 0.7049791289212733 -3.367635507955935e-07 -0.0987986389048722 -1.6815 0.7049812229707282 0.7049797752991553 -3.3863157034713653e-07 -0.09879900166441617 -1.6816000000000002 0.7049818627975768 0.7049804215025741 -3.4043122052601626e-07 -0.09879936431508386 -1.6817 0.7049825024124136 0.7049810675308503 -3.421621086255322e-07 -0.09879972685690758 -1.6818000000000002 0.7049831418160372 0.7049817133833007 -3.438238578012953e-07 -0.09880008928991961 -1.6819000000000002 0.7049837810092501 0.7049823590592379 -3.4541610718918925e-07 -0.09880045161415213 -1.682 0.7049844199928589 0.7049830045579712 -3.4693851194006475e-07 -0.09880081382963746 -1.6821000000000002 0.7049850587676736 0.7049836498788062 -3.483907433793343e-07 -0.09880117593640786 -1.6822000000000001 0.7049856973345068 0.7049842950210452 -3.4977248897227753e-07 -0.09880153793449552 -1.6823000000000001 0.7049863356941752 0.7049849399839869 -3.5108345248363593e-07 -0.09880189982393267 -1.6824000000000001 0.7049869738474978 0.7049855847669275 -3.523233539984294e-07 -0.0988022616047515 -1.6825 0.7049876117952965 0.7049862293691604 -3.534919299358341e-07 -0.09880262327698423 -1.6826 0.7049882495383959 0.7049868737899763 -3.5458893320183815e-07 -0.09880298484066308 -1.6827 0.7049888870776232 0.7049875180286633 -3.556141331823026e-07 -0.09880334629582022 -1.6828 0.7049895244138076 0.7049881620845073 -3.5656731582622836e-07 -0.0988037076424878 -1.6829 0.7049901615477803 0.7049888059567919 -3.5744828358330594e-07 -0.09880406888069802 -1.683 0.7049907984803747 0.7049894496447991 -3.582568556120824e-07 -0.09880443001048304 -1.6831 0.704991435212426 0.7049900931478088 -3.589928676828169e-07 -0.098804791031875 -1.6832 0.7049920717447704 0.7049907364650998 -3.59656172274625e-07 -0.09880515194490602 -1.6833000000000002 0.7049927080782457 0.704991379595949 -3.6024663861711215e-07 -0.09880551274960821 -1.6834 0.7049933442136908 0.7049920225396323 -3.6076415260710704e-07 -0.09880587344601371 -1.6835 0.7049939801519464 0.7049926652954248 -3.612086169821338e-07 -0.0988062340341547 -1.6836000000000002 0.7049946158938528 0.7049933078626004 -3.615799512302065e-07 -0.0988065945140632 -1.6837 0.7049952514402515 0.7049939502404323 -3.618780916661568e-07 -0.09880695488577133 -1.6838000000000002 0.7049958867919848 0.7049945924281934 -3.62102991383062e-07 -0.09880731514931113 -1.6839000000000002 0.7049965219498946 0.7049952344251562 -3.622546202869392e-07 -0.09880767530471471 -1.684 0.7049971569148235 0.7049958762305936 -3.6233296513837887e-07 -0.09880803535201416 -1.6841000000000002 0.7049977916876138 0.7049965178437771 -3.6233802947621685e-07 -0.09880839529124148 -1.6842000000000001 0.7049984262691074 0.7049971592639803 -3.6226983366610677e-07 -0.09880875512242876 -1.6843000000000001 0.7049990606601456 0.7049978004904756 -3.621284148450088e-07 -0.098809114845608 -1.6844000000000001 0.7049996948615698 0.7049984415225372 -3.6191382696976193e-07 -0.09880947446081126 -1.6845 0.70500032887422 0.704999082359439 -3.6162614077545063e-07 -0.09880983396807054 -1.6846 0.7050009626989354 0.7049997230004568 -3.61265443699077e-07 -0.09881019336741786 -1.6847 0.7050015963365539 0.7050003634448666 -3.6083183994894963e-07 -0.09881055265888519 -1.6848 0.7050022297879124 0.7050010036919466 -3.603254503659059e-07 -0.09881091184250457 -1.6849 0.705002863053846 0.7050016437409761 -3.5974641250657857e-07 -0.09881127091830792 -1.685 0.7050034961351881 0.7050022835912358 -3.590948805393124e-07 -0.0988116298863273 -1.6851 0.7050041290327702 0.7050029232420086 -3.583710252164085e-07 -0.09881198874659458 -1.6852 0.705004761747422 0.7050035626925792 -3.5757503381861344e-07 -0.09881234749914174 -1.6853000000000002 0.705005394279971 0.7050042019422349 -3.5670711012736334e-07 -0.09881270614400074 -1.6854 0.7050060266312418 0.7050048409902645 -3.557674743762118e-07 -0.09881306468120352 -1.6855 0.7050066588020572 0.7050054798359601 -3.547563631953188e-07 -0.09881342311078196 -1.6856000000000002 0.7050072907932363 0.7050061184786163 -3.5367402949348925e-07 -0.09881378143276803 -1.6857 0.7050079226055963 0.7050067569175305 -3.5252074247899e-07 -0.0988141396471936 -1.6858000000000002 0.7050085542399505 0.7050073951520035 -3.51296787569344e-07 -0.0988144977540906 -1.6859000000000002 0.7050091856971092 0.7050080331813386 -3.5000246627336917e-07 -0.09881485575349089 -1.686 0.7050098169778796 0.7050086710048434 -3.4863809619117836e-07 -0.09881521364542634 -1.6861000000000002 0.7050104480830646 0.7050093086218288 -3.4720401086846264e-07 -0.09881557142992886 -1.6862000000000001 0.7050110790134639 0.705009946031609 -3.457005597548579e-07 -0.0988159291070303 -1.6863000000000001 0.7050117097698729 0.7050105832335026 -3.4412810812761707e-07 -0.0988162866767625 -1.6864000000000001 0.7050123403530834 0.705011220226832 -3.424870369875266e-07 -0.09881664413915732 -1.6865 0.7050129707638819 0.7050118570109241 -3.407777429409453e-07 -0.09881700149424655 -1.6866 0.7050136010030517 0.7050124935851099 -3.390006381165378e-07 -0.09881735874206204 -1.6867 0.7050142310713702 0.7050131299487251 -3.3715615011670197e-07 -0.09881771588263556 -1.6868 0.7050148609696113 0.7050137661011108 -3.352447218857302e-07 -0.09881807291599902 -1.6869 0.7050154906985429 0.7050144020416118 -3.3326681153633686e-07 -0.09881842984218413 -1.687 0.7050161202589287 0.7050150377695791 -3.312228923635363e-07 -0.09881878666122271 -1.6871 0.705016749651526 0.7050156732843682 -3.2911345262953695e-07 -0.0988191433731465 -1.6872 0.7050173788770879 0.7050163085853404 -3.2693899548741356e-07 -0.09881949997798735 -1.6873000000000002 0.705018007936361 0.7050169436718623 -3.247000388700849e-07 -0.09881985647577696 -1.6874 0.7050186368300868 0.7050175785433065 -3.223971153584748e-07 -0.09882021286654712 -1.6875 0.7050192655590002 0.705018213199051 -3.2003077202191754e-07 -0.0988205691503295 -1.6876000000000002 0.7050198941238308 0.7050188476384802 -3.176015703557078e-07 -0.09882092532715589 -1.6877 0.7050205225253013 0.7050194818609846 -3.151100860937506e-07 -0.09882128139705798 -1.6878000000000002 0.7050211507641289 0.7050201158659609 -3.125569090767222e-07 -0.0988216373600675 -1.6879000000000002 0.7050217788410233 0.7050207496528127 -3.099426431688035e-07 -0.09882199321621621 -1.688 0.7050224067566884 0.7050213832209493 -3.0726790602869647e-07 -0.09882234896553568 -1.6881000000000002 0.7050230345118205 0.7050220165697877 -3.0453332903329633e-07 -0.0988227046080577 -1.6882000000000001 0.7050236621071098 0.7050226496987515 -3.017395570903414e-07 -0.0988230601438139 -1.6883000000000001 0.7050242895432386 0.7050232826072713 -2.9888724850310466e-07 -0.09882341557283597 -1.6884000000000001 0.7050249168208829 0.7050239152947848 -2.9597707481773816e-07 -0.0988237708951556 -1.6885 0.7050255439407103 0.7050245477607369 -2.930097206428617e-07 -0.09882412611080431 -1.6886 0.7050261709033816 0.7050251800045806 -2.899858835177238e-07 -0.09882448121981385 -1.6887 0.7050267977095498 0.705025812025776 -2.8690627373872957e-07 -0.09882483622221586 -1.6888 0.7050274243598602 0.7050264438237912 -2.8377161417555974e-07 -0.09882519111804194 -1.6889 0.7050280508549498 0.7050270753981018 -2.8058264012892353e-07 -0.0988255459073237 -1.689 0.7050286771954479 0.7050277067481918 -2.773400991258612e-07 -0.0988259005900927 -1.6891 0.7050293033819756 0.7050283378735531 -2.740447507983135e-07 -0.09882625516638059 -1.6892 0.7050299294151456 0.7050289687736861 -2.706973666402601e-07 -0.09882660963621898 -1.6893000000000002 0.7050305552955622 0.7050295994480993 -2.672987298689422e-07 -0.0988269639996393 -1.6894 0.7050311810238215 0.7050302298963098 -2.6384963524098137e-07 -0.09882731825667329 -1.6895 0.7050318066005101 0.7050308601178437 -2.603508888372741e-07 -0.09882767240735243 -1.6896000000000002 0.7050324320262067 0.7050314901122354 -2.5680330792074435e-07 -0.09882802645170828 -1.6897 0.7050330573014805 0.7050321198790281 -2.532077206796046e-07 -0.09882838038977235 -1.6898000000000002 0.7050336824268919 0.7050327494177746 -2.495649661093946e-07 -0.09882873422157622 -1.6899000000000002 0.7050343074029926 0.7050333787280363 -2.4587589377012e-07 -0.0988290879471514 -1.69 0.7050349322303242 0.7050340078093837 -2.4214136358502447e-07 -0.09882944156652938 -1.6901000000000002 0.7050355569094193 0.7050346366613969 -2.3836224568793418e-07 -0.09882979507974164 -1.6902000000000001 0.7050361814408017 0.7050352652836653 -2.3453942015611018e-07 -0.09883014848681976 -1.6903000000000001 0.7050368058249845 0.7050358936757881 -2.3067377684718449e-07 -0.09883050178779516 -1.6904000000000001 0.705037430062472 0.7050365218373738 -2.2676621519446272e-07 -0.0988308549826993 -1.6905 0.7050380541537584 0.7050371497680408 -2.2281764396406278e-07 -0.09883120807156372 -1.6906 0.705038678099328 0.7050377774674172 -2.18828981084912e-07 -0.09883156105441983 -1.6907 0.705039301899655 0.7050384049351412 -2.148011534058858e-07 -0.09883191393129907 -1.6908 0.705039925555204 0.7050390321708611 -2.1073509649111033e-07 -0.0988322667022329 -1.6909 0.7050405490664293 0.7050396591742347 -2.0663175440138737e-07 -0.09883261936725274 -1.691 0.7050411724337747 0.7050402859449307 -2.0249207947908854e-07 -0.09883297192639001 -1.6911 0.705041795657674 0.7050409124826276 -1.983170321226413e-07 -0.09883332437967612 -1.6912 0.7050424187385504 0.7050415387870148 -1.9410758056101485e-07 -0.0988336767271425 -1.6913000000000002 0.7050430416768168 0.7050421648577916 -1.898647006316756e-07 -0.09883402896882049 -1.6914 0.7050436644728751 0.7050427906946681 -1.8558937557588973e-07 -0.09883438110474152 -1.6915 0.7050442871271174 0.705043416297365 -1.8128259576810635e-07 -0.09883473313493697 -1.6916000000000002 0.7050449096399242 0.7050440416656136 -1.7694535851819904e-07 -0.09883508505943817 -1.6917 0.7050455320116655 0.705044666799156 -1.7257866782166564e-07 -0.0988354368782765 -1.6918000000000002 0.7050461542427011 0.705045291697745 -1.68183534167074e-07 -0.09883578859148331 -1.6919000000000002 0.7050467763333792 0.7050459163611444 -1.6376097425503666e-07 -0.09883614019908998 -1.692 0.7050473982840367 0.7050465407891292 -1.593120107761664e-07 -0.09883649170112774 -1.6921000000000002 0.7050480200950002 0.7050471649814847 -1.54837672192501e-07 -0.09883684309762797 -1.6922000000000001 0.7050486417665851 0.7050477889380081 -1.503389924738252e-07 -0.09883719438862203 -1.6923000000000001 0.7050492632990953 0.705048412658507 -1.4581701088256516e-07 -0.09883754557414111 -1.6924000000000001 0.7050498846928237 0.7050490361428006 -1.4127277172051866e-07 -0.09883789665421658 -1.6925 0.7050505059480516 0.7050496593907196 -1.367073240964023e-07 -0.09883824762887974 -1.6926 0.7050511270650499 0.7050502824021052 -1.3212172167258174e-07 -0.09883859849816187 -1.6927 0.7050517480440769 0.7050509051768103 -1.275170224204758e-07 -0.09883894926209416 -1.6928 0.7050523688853805 0.7050515277146996 -1.228942883985118e-07 -0.09883929992070795 -1.6929 0.7050529895891966 0.7050521500156484 -1.1825458548324341e-07 -0.09883965047403442 -1.693 0.7050536101557499 0.7050527720795439 -1.1359898313169359e-07 -0.09884000092210486 -1.6931 0.7050542305852534 0.7050533939062851 -1.0892855414890157e-07 -0.0988403512649505 -1.6932 0.7050548508779089 0.7050540154957816 -1.0424437441990814e-07 -0.0988407015026025 -1.6933000000000002 0.7050554710339061 0.7050546368479553 -9.954752266255751e-08 -0.09884105163509216 -1.6934 0.7050560910534235 0.7050552579627396 -9.483908020024856e-08 -0.09884140166245063 -1.6935 0.7050567109366277 0.7050558788400794 -9.012013068958324e-08 -0.09884175158470909 -1.6936000000000002 0.7050573306836738 0.7050564994799308 -8.5391759888781e-08 -0.09884210140189874 -1.6937 0.7050579502947056 0.7050571198822622 -8.065505539660289e-08 -0.09884245111405078 -1.6938000000000002 0.7050585697698546 0.7050577400470533 -7.591110640602083e-08 -0.09884280072119639 -1.6939000000000002 0.7050591891092408 0.7050583599742956 -7.116100345701953e-08 -0.0988431502233667 -1.694 0.7050598083129724 0.705058979663992 -6.640583817725532e-08 -0.09884349962059286 -1.6941000000000002 0.7050604273811462 0.7050595991161575 -6.164670304353165e-08 -0.09884384891290598 -1.6942000000000002 0.7050610463138471 0.7050602183308186 -5.688469112115693e-08 -0.09884419810033729 -1.6943000000000001 0.7050616651111481 0.7050608373080134 -5.212089581631274e-08 -0.0988445471829178 -1.6944000000000001 0.7050622837731105 0.7050614560477919 -4.7356410624085216e-08 -0.0988448961606787 -1.6945 0.7050629022997844 0.7050620745502154 -4.2592328878881744e-08 -0.09884524503365104 -1.6946 0.7050635206912075 0.7050626928153575 -3.7829743504305506e-08 -0.09884559380186593 -1.6947 0.7050641389474062 0.7050633108433029 -3.3069746761078475e-08 -0.0988459424653545 -1.6948 0.7050647570683949 0.7050639286341484 -2.831342999507283e-08 -0.09884629102414781 -1.6949 0.7050653750541764 0.7050645461880021 -2.356188339228127e-08 -0.09884663947827688 -1.695 0.705065992904742 0.7050651635049839 -1.8816195722620027e-08 -0.09884698782777278 -1.6951 0.7050666106200713 0.7050657805852256 -1.4077454096091818e-08 -0.0988473360726666 -1.6952 0.705067228200132 0.7050663974288705 -9.346743711034083e-09 -0.0988476842129894 -1.6953000000000003 0.7050678456448805 0.7050670140360731 -4.625147600849366e-09 -0.09884803224877219 -1.6954 0.7050684629542614 0.7050676304069996 8.625360148339922e-11 -0.09884838018004596 -1.6955 0.7050690801282078 0.7050682465418281 4.786381919280602e-09 -0.09884872800684175 -1.6956000000000002 0.7050696971666413 0.7050688624407476 9.474162277617326e-09 -0.09884907572919055 -1.6957 0.7050703140694721 0.705069478103959 1.4148522755295934e-08 -0.09884942334712335 -1.6958000000000002 0.7050709308365987 0.7050700935316747 1.8808394807758033e-08 -0.09884977086067118 -1.6959000000000002 0.7050715474679082 0.7050707087241181 2.3452713543772874e-08 -0.09885011826986498 -1.696 0.7050721639632768 0.7050713236815245 2.8080417945747227e-08 -0.09885046557473576 -1.6961000000000002 0.7050727803225687 0.7050719384041398 3.269045111171931e-08 -0.09885081277531446 -1.6962000000000002 0.705073396545637 0.7050725528922215 3.728176051556731e-08 -0.098851159871632 -1.6963000000000001 0.705074012632324 0.7050731671460384 4.1853298221247726e-08 -0.09885150686371932 -1.6964000000000001 0.7050746285824605 0.7050737811658704 4.640402114647335e-08 -0.09885185375160743 -1.6965 0.705075244395866 0.7050743949520084 5.093289127781897e-08 -0.0988522005353272 -1.6966 0.7050758600723492 0.7050750085047541 5.543887593092989e-08 -0.09885254721490953 -1.6967 0.7050764756117077 0.705075621824421 5.992094796909708e-08 -0.09885289379038537 -1.6968 0.7050770910137281 0.7050762349113326 6.437808604091433e-08 -0.09885324026178562 -1.6969 0.7050777062781863 0.7050768477658238 6.880927481967003e-08 -0.09885358662914114 -1.697 0.705078321404847 0.7050774603882398 7.321350522192238e-08 -0.09885393289248279 -1.6971 0.7050789363934646 0.7050780727789372 7.758977465209538e-08 -0.09885427905184148 -1.6972 0.7050795512437824 0.7050786849382829 8.193708721411508e-08 -0.09885462510724807 -1.6973000000000003 0.7050801659555335 0.7050792968666539 8.625445395080145e-08 -0.09885497105873338 -1.6974 0.7050807805284403 0.7050799085644387 9.054089306764768e-08 -0.09885531690632832 -1.6975 0.7050813949622148 0.7050805200320354 9.47954301618037e-08 -0.09885566265006368 -1.6976000000000002 0.7050820092565584 0.7050811312698526 9.901709841636519e-08 -0.09885600828997028 -1.6977 0.7050826234111625 0.7050817422783091 1.0320493884496962e-07 -0.09885635382607894 -1.6978000000000002 0.7050832374257081 0.7050823530578343 1.0735800051037137e-07 -0.09885669925842046 -1.6979000000000002 0.7050838512998663 0.7050829636088671 1.1147534071179188e-07 -0.09885704458702566 -1.698 0.7050844650332979 0.7050835739318568 1.155560252520671e-07 -0.09885738981192528 -1.6981000000000002 0.7050850786256546 0.7050841840272624 1.1959912860765032e-07 -0.09885773493315021 -1.6982000000000002 0.7050856920765773 0.7050847938955527 1.236037341333096e-07 -0.09885807995073118 -1.6983000000000001 0.7050863053856975 0.7050854035372061 1.2756893429111127e-07 -0.09885842486469888 -1.6984000000000001 0.7050869185526369 0.7050860129527107 1.3149383085164779e-07 -0.09885876967508413 -1.6985 0.7050875315770083 0.705086622142564 1.3537753510220463e-07 -0.09885911438191766 -1.6986 0.7050881444584145 0.7050872311072733 1.3921916804451873e-07 -0.09885945898523023 -1.6987 0.7050887571964491 0.7050878398473547 1.4301786057865917e-07 -0.09885980348505255 -1.6988 0.7050893697906968 0.7050884483633334 1.4677275372160237e-07 -0.09886014788141534 -1.6989 0.7050899822407328 0.7050890566557443 1.5048299877029603e-07 -0.09886049217434933 -1.699 0.7050905945461233 0.7050896647251305 1.5414775754105103e-07 -0.0988608363638852 -1.6991 0.7050912067064261 0.7050902725720443 1.577662025013804e-07 -0.09886118045005363 -1.6992 0.7050918187211896 0.7050908801970466 1.6133751702326893e-07 -0.0988615244328853 -1.6993000000000003 0.7050924305899545 0.7050914876007068 1.648608955046038e-07 -0.09886186831241088 -1.6994 0.7050930423122521 0.7050920947836037 1.6833554359815817e-07 -0.09886221208866111 -1.6995 0.7050936538876056 0.7050927017463231 1.7176067834689945e-07 -0.09886255576166658 -1.6996000000000002 0.7050942653155302 0.70509330848946 1.7513552840256463e-07 -0.09886289933145798 -1.6997 0.7050948765955325 0.7050939150136166 1.7845933418178528e-07 -0.09886324279806591 -1.6998000000000002 0.7050954877271114 0.7050945213194042 1.8173134802915158e-07 -0.09886358616152102 -1.6999000000000002 0.7050960987097579 0.7050951274074411 1.8495083438374582e-07 -0.09886392942185389 -1.7 0.7050967095429552 0.7050957332783534 1.8811706995608413e-07 -0.09886427257909519 -1.7001000000000002 0.7050973202261789 0.7050963389327753 1.9122934388424162e-07 -0.0988646156332755 -1.7002000000000002 0.7050979307588974 0.7050969443713482 1.9428695792814143e-07 -0.09886495858442548 -1.7003000000000001 0.705098541140571 0.7050975495947203 1.9728922655976033e-07 -0.09886530143257562 -1.7004000000000001 0.7050991513706535 0.7050981546035477 2.002354771400705e-07 -0.09886564417775652 -1.7005 0.7050997614485912 0.7050987593984928 2.031250501133286e-07 -0.09886598681999875 -1.7006000000000001 0.7051003713738242 0.7050993639802257 2.0595729911462857e-07 -0.09886632935933289 -1.7007 0.7051009811457849 0.705099968349423 2.0873159109133232e-07 -0.09886667179578949 -1.7008 0.7051015907638996 0.7051005725067674 2.11447306514706e-07 -0.0988670141293991 -1.7009 0.705102200227588 0.7051011764529485 2.1410383946318667e-07 -0.09886735636019223 -1.701 0.7051028095362633 0.7051017801886621 2.1670059776116024e-07 -0.09886769848819939 -1.7011 0.7051034186893328 0.7051023837146102 2.1923700314202543e-07 -0.09886804051345112 -1.7012 0.7051040276861975 0.7051029870315009 2.2171249131758275e-07 -0.09886838243597794 -1.7013000000000003 0.7051046365262529 0.7051035901400478 2.241265122174263e-07 -0.09886872425581028 -1.7014 0.7051052452088881 0.7051041930409705 2.2647852997159656e-07 -0.09886906597297866 -1.7015 0.7051058537334874 0.7051047957349943 2.2876802310139999e-07 -0.09886940758751363 -1.7016000000000002 0.7051064620994294 0.7051053982228497 2.3099448465124794e-07 -0.09886974909944561 -1.7017 0.7051070703060869 0.7051060005052721 2.331574222511068e-07 -0.09887009050880505 -1.7018000000000002 0.7051076783528281 0.7051066025830026 2.3525635829690916e-07 -0.09887043181562241 -1.7019000000000002 0.7051082862390161 0.7051072044567869 2.3729082993667605e-07 -0.09887077301992814 -1.702 0.7051088939640097 0.7051078061273754 2.3926038930643934e-07 -0.0988711141217527 -1.7021000000000002 0.7051095015271622 0.7051084075955231 2.411646035510584e-07 -0.09887145512112648 -1.7022 0.7051101089278229 0.7051090088619898 2.4300305493524244e-07 -0.09887179601807988 -1.7023000000000001 0.7051107161653369 0.7051096099275391 2.4477534095457276e-07 -0.0988721368126434 -1.7024000000000001 0.7051113232390449 0.705110210792939 2.464810743563195e-07 -0.09887247750484736 -1.7025 0.7051119301482838 0.7051108114589614 2.48119883305975e-07 -0.09887281809472216 -1.7026000000000001 0.7051125368923865 0.7051114119263818 2.4969141145664286e-07 -0.09887315858229821 -1.7027 0.7051131434706824 0.7051120121959795 2.511953179490378e-07 -0.09887349896760585 -1.7028 0.7051137498824975 0.7051126122685369 2.5263127759883597e-07 -0.09887383925067544 -1.7029 0.7051143561271547 0.7051132121448405 2.5399898084810246e-07 -0.09887417943153738 -1.703 0.705114962203973 0.705113811825679 2.5529813395958056e-07 -0.09887451951022198 -1.7031 0.7051155681122689 0.7051144113118445 2.565284589473027e-07 -0.09887485948675961 -1.7032 0.705116173851356 0.7051150106041318 2.576896937223072e-07 -0.09887519936118055 -1.7033000000000003 0.7051167794205457 0.7051156097033384 2.5878159216202734e-07 -0.09887553913351518 -1.7034 0.7051173848191465 0.705116208610264 2.598039240894745e-07 -0.0988758788037938 -1.7035 0.7051179900464648 0.7051168073257109 2.6075647536344393e-07 -0.09887621837204674 -1.7036000000000002 0.7051185951018047 0.7051174058504831 2.6163904792014803e-07 -0.09887655783830428 -1.7037 0.7051191999844684 0.7051180041853864 2.6245145980791085e-07 -0.09887689720259663 -1.7038000000000002 0.7051198046937561 0.7051186023312286 2.6319354521492366e-07 -0.09887723646495411 -1.7039000000000002 0.7051204092289671 0.7051192002888194 2.6386515460108395e-07 -0.09887757562540699 -1.704 0.7051210135893988 0.7051197980589694 2.6446615451064526e-07 -0.09887791468398559 -1.7041000000000002 0.7051216177743473 0.7051203956424907 2.6499642782895627e-07 -0.0988782536407201 -1.7042 0.7051222217831077 0.705120993040196 2.6545587365062184e-07 -0.09887859249564075 -1.7043000000000001 0.7051228256149744 0.7051215902528996 2.658444073766475e-07 -0.09887893124877783 -1.7044000000000001 0.705123429269241 0.7051221872814155 2.6616196070750053e-07 -0.09887926990016152 -1.7045 0.7051240327452004 0.7051227841265594 2.6640848163617115e-07 -0.09887960844982206 -1.7046000000000001 0.7051246360421448 0.7051233807891462 2.6658393450368356e-07 -0.09887994689778962 -1.7047 0.7051252391593672 0.7051239772699918 2.6668829988807374e-07 -0.09888028524409444 -1.7048 0.7051258420961597 0.7051245735699114 2.667215748403118e-07 -0.09888062348876667 -1.7049 0.7051264448518149 0.7051251696897209 2.666837725581739e-07 -0.09888096163183654 -1.705 0.7051270474256256 0.7051257656302352 2.6657492262910365e-07 -0.09888129967333421 -1.7051 0.705127649816885 0.7051263613922686 2.663950709261287e-07 -0.09888163761328979 -1.7052 0.7051282520248875 0.7051269569766352 2.6614427961479947e-07 -0.09888197545173352 -1.7053000000000003 0.7051288540489276 0.7051275523841478 2.6582262709073934e-07 -0.09888231318869549 -1.7054 0.7051294558883013 0.7051281476156184 2.6543020800046113e-07 -0.09888265082420587 -1.7055 0.7051300575423057 0.7051287426718573 2.6496713322748944e-07 -0.09888298835829473 -1.7056000000000002 0.7051306590102393 0.705129337553674 2.6443352978133827e-07 -0.09888332579099222 -1.7057 0.7051312602914022 0.7051299322618763 2.638295408738389e-07 -0.09888366312232849 -1.7058000000000002 0.7051318613850959 0.70513052679727 2.631553258289343e-07 -0.09888400035233358 -1.7059000000000002 0.7051324622906238 0.705131121160659 2.624110599785956e-07 -0.09888433748103762 -1.706 0.7051330630072921 0.7051317153528455 2.6159693472527223e-07 -0.0988846745084707 -1.7061000000000002 0.7051336635344084 0.7051323093746289 2.6071315744474743e-07 -0.0988850114346629 -1.7062 0.705134263871283 0.7051329032268066 2.59759951430627e-07 -0.09888534825964425 -1.7063000000000001 0.7051348640172289 0.7051334969101732 2.587375558249505e-07 -0.0988856849834449 -1.7064000000000001 0.7051354639715612 0.7051340904255206 2.5764622560431327e-07 -0.09888602160609472 -1.7065 0.7051360637335988 0.7051346837736373 2.564862315035388e-07 -0.09888635812762389 -1.7066000000000001 0.7051366633026634 0.7051352769553094 2.5525785989077843e-07 -0.0988866945480624 -1.7067 0.7051372626780796 0.7051358699713198 2.539614127605727e-07 -0.09888703086744033 -1.7068 0.7051378618591757 0.7051364628224472 2.5259720765752336e-07 -0.09888736708578762 -1.7069 0.7051384608452835 0.7051370555094673 2.5116557754445434e-07 -0.09888770320313434 -1.707 0.7051390596357385 0.7051376480331515 2.496668707885341e-07 -0.09888803921951042 -1.7071 0.7051396582298801 0.7051382403942679 2.4810145106413106e-07 -0.09888837513494587 -1.7072 0.7051402566270517 0.7051388325935799 2.4646969722097456e-07 -0.09888871094947069 -1.7073000000000003 0.7051408548266014 0.7051394246318474 2.447720032078271e-07 -0.09888904666311485 -1.7074 0.705141452827881 0.7051400165098252 2.4300877803778986e-07 -0.09888938227590832 -1.7075 0.7051420506302473 0.7051406082282635 2.411804456078914e-07 -0.09888971778788104 -1.7076000000000002 0.7051426482330618 0.7051411997879085 2.3928744462969886e-07 -0.09889005319906298 -1.7077 0.7051432456356905 0.7051417911895004 2.3733022854605101e-07 -0.09889038850948403 -1.7078000000000002 0.7051438428375048 0.7051423824337754 2.353092653784028e-07 -0.09889072371917414 -1.7079000000000002 0.705144439837881 0.705142973521464 2.332250376574363e-07 -0.09889105882816326 -1.708 0.7051450366362009 0.7051435644532914 2.31078042339794e-07 -0.09889139383648127 -1.7081000000000002 0.7051456332318518 0.7051441552299769 2.288687905513398e-07 -0.09889172874415803 -1.7082 0.7051462296242268 0.705144745852235 2.2659780760103665e-07 -0.09889206355122354 -1.7083000000000002 0.7051468258127241 0.7051453363207736 2.2426563278665768e-07 -0.09889239825770758 -1.7084000000000001 0.7051474217967486 0.7051459266362949 2.2187281932539715e-07 -0.09889273286364009 -1.7085 0.7051480175757108 0.7051465167994955 2.194199341665204e-07 -0.0988930673690509 -1.7086000000000001 0.7051486131490279 0.7051471068110646 2.1690755790809702e-07 -0.09889340177396992 -1.7087 0.7051492085161228 0.7051476966716862 2.143362845853647e-07 -0.09889373607842696 -1.7088 0.7051498036764253 0.705148286382037 2.1170672162562632e-07 -0.09889407028245184 -1.7089 0.7051503986293721 0.7051488759427872 2.090194895880415e-07 -0.09889440438607443 -1.709 0.705150993374406 0.7051494653546004 2.062752221636266e-07 -0.09889473838932453 -1.7091 0.7051515879109775 0.7051500546181331 2.0347456588382107e-07 -0.098895072292232 -1.7092 0.7051521822385438 0.7051506437340342 2.0061818007885424e-07 -0.09889540609482661 -1.7093000000000003 0.705152776356569 0.7051512327029464 1.9770673663835336e-07 -0.09889573979713817 -1.7094 0.7051533702645253 0.705151821525504 1.947409198933825e-07 -0.09889607339919643 -1.7095 0.7051539639618917 0.7051524102023345 1.9172142649501178e-07 -0.09889640690103123 -1.7096000000000002 0.7051545574481548 0.7051529987340577 1.886489651610479e-07 -0.0988967403026723 -1.7097 0.7051551507228095 0.7051535871212851 1.855242565788895e-07 -0.09889707360414944 -1.7098000000000002 0.705155743785358 0.7051541753646209 1.823480332077687e-07 -0.09889740680549237 -1.7099000000000002 0.7051563366353105 0.7051547634646611 1.7912103914691224e-07 -0.09889773990673084 -1.71 0.7051569292721855 0.7051553514219937 1.7584402986839387e-07 -0.0988980729078946 -1.7101000000000002 0.7051575216955099 0.7051559392371983 1.725177721373372e-07 -0.09889840580901339 -1.7102 0.7051581139048186 0.705156526910846 1.6914304381762668e-07 -0.09889873861011694 -1.7103000000000002 0.7051587058996551 0.7051571144434996 1.6572063363251566e-07 -0.09889907131123493 -1.7104000000000001 0.7051592976795711 0.7051577018357135 1.622513410189097e-07 -0.09889940391239704 -1.7105 0.7051598892441278 0.7051582890880328 1.587359759747109e-07 -0.09889973641363302 -1.7106000000000001 0.7051604805928939 0.7051588762009945 1.5517535880207878e-07 -0.09890006881497249 -1.7107 0.7051610717254484 0.7051594631751262 1.5157031993742742e-07 -0.09890040111644519 -1.7108 0.7051616626413788 0.7051600500109465 1.4792169981958647e-07 -0.09890073331808077 -1.7109 0.7051622533402812 0.7051606367089651 1.4423034859489814e-07 -0.09890106541990887 -1.711 0.7051628438217614 0.7051612232696822 1.4049712599231712e-07 -0.09890139742195919 -1.7111 0.7051634340854344 0.705161809693589 1.3672290109095764e-07 -0.09890172932426129 -1.7112 0.7051640241309245 0.7051623959811668 1.3290855212580444e-07 -0.0989020611268449 -1.7113000000000003 0.705164613957866 0.705162982132888 1.2905496626566815e-07 -0.09890239282973962 -1.7114 0.7051652035659022 0.7051635681492145 1.2516303946746854e-07 -0.09890272443297504 -1.7115 0.7051657929546862 0.7051641540305991 1.212336761882704e-07 -0.09890305593658077 -1.7116000000000002 0.7051663821238812 0.705164739777485 1.172677892083418e-07 -0.09890338734058647 -1.7117 0.7051669710731596 0.7051653253903046 1.1326629946808997e-07 -0.09890371864502165 -1.7118000000000002 0.7051675598022046 0.7051659108694812 1.0923013576275009e-07 -0.0989040498499159 -1.7119000000000002 0.7051681483107088 0.7051664962154275 1.0516023458626012e-07 -0.09890438095529883 -1.712 0.7051687365983753 0.7051670814285464 1.0105753991615507e-07 -0.09890471196119996 -1.7121000000000002 0.705169324664917 0.7051676665092308 9.692300296723633e-08 -0.0989050428676489 -1.7122 0.7051699125100572 0.7051682514578625 9.275758197646589e-08 -0.09890537367467517 -1.7123000000000002 0.7051705001335298 0.7051688362748136 8.856224200173846e-08 -0.09890570438230831 -1.7124000000000001 0.705171087535079 0.7051694209604454 8.433795468248961e-08 -0.09890603499057783 -1.7125 0.705171674714459 0.7051700055151093 8.008569800897758e-08 -0.09890636549951332 -1.7126000000000001 0.7051722616714352 0.7051705899391453 7.58064561141164e-08 -0.09890669590914423 -1.7127000000000001 0.7051728484057832 0.7051711742328832 7.150121902887996e-08 -0.09890702621950008 -1.7128 0.7051734349172896 0.7051717583966426 6.717098247413511e-08 -0.09890735643061042 -1.7129 0.7051740212057513 0.705172342430731 6.281674759349432e-08 -0.09890768654250466 -1.713 0.705174607270976 0.7051729263354464 5.8439520772904374e-08 -0.09890801655521231 -1.7131 0.705175193112783 0.7051735101110752 5.4040313352682334e-08 -0.09890834646876284 -1.7132 0.7051757787310011 0.7051740937578937 4.9620141440165355e-08 -0.09890867628318575 -1.7133000000000003 0.7051763641254714 0.7051746772761665 4.5180025658175804e-08 -0.09890900599851046 -1.7134 0.7051769492960451 0.7051752606661468 4.072099088134329e-08 -0.09890933561476639 -1.7135 0.7051775342425848 0.7051758439280776 3.624406606436703e-08 -0.09890966513198302 -1.7136000000000002 0.705178118964964 0.7051764270621912 3.175028394364343e-08 -0.09890999455018976 -1.7137 0.7051787034630672 0.7051770100687074 2.7240680827364527e-08 -0.09891032386941602 -1.7138000000000002 0.70517928773679 0.705177592947836 2.2716296350921983e-08 -0.0989106530896912 -1.7139000000000002 0.7051798717860398 0.7051781756997753 1.8178173239249973e-08 -0.09891098221104477 -1.714 0.7051804556107345 0.7051787583247119 1.3627357064831258e-08 -0.09891131123350609 -1.7141000000000002 0.7051810392108032 0.7051793408228215 9.06489600049909e-09 -0.09891164015710449 -1.7142 0.7051816225861868 0.705179923194269 4.491840591321072e-09 -0.09891196898186942 -1.7143000000000002 0.7051822057368371 0.7051805054392071 -9.075649173156952e-11 -0.09891229770783022 -1.7144000000000001 0.7051827886627171 0.7051810875577776 -4.681840699849449e-09 -0.09891262633501623 -1.7145 0.7051833713638015 0.7051816695501114 -9.280355844042132e-09 -0.09891295486345683 -1.7146000000000001 0.7051839538400756 0.7051822514163273 -1.3885244338866787e-08 -0.09891328329318134 -1.7147000000000001 0.705184536091537 0.7051828331565333 -1.849544744572315e-08 -0.09891361162421919 -1.7148 0.7051851181181936 0.7051834147708258 -2.310990551701586e-08 -0.09891393985659958 -1.7149 0.7051856999200654 0.7051839962592897 -2.7727558237714695e-08 -0.09891426799035187 -1.715 0.7051862814971834 0.7051845776219987 -3.234734487211899e-08 -0.09891459602550536 -1.7151 0.7051868628495904 0.7051851588590152 -3.696820450108107e-08 -0.09891492396208935 -1.7152 0.7051874439773398 0.70518573997039 -4.15890762769564e-08 -0.09891525180013318 -1.7153000000000003 0.7051880248804971 0.7051863209561626 -4.620889965310207e-08 -0.09891557953966611 -1.7154 0.7051886055591386 0.7051869018163613 -5.0826614637553e-08 -0.0989159071807174 -1.7155 0.7051891860133521 0.7051874825510027 -5.5441162032142735e-08 -0.09891623472331629 -1.7156000000000002 0.7051897662432369 0.7051880631600924 -6.00514836741721e-08 -0.09891656216749209 -1.7157 0.7051903462489033 0.7051886436436242 -6.465652268358019e-08 -0.09891688951327401 -1.7158000000000002 0.7051909260304733 0.7051892240015811 -6.92552237016586e-08 -0.09891721676069132 -1.7159 0.7051915055880795 0.7051898042339347 -7.384653312935904e-08 -0.09891754390977324 -1.716 0.7051920849218667 0.705190384340645 -7.842939937861143e-08 -0.09891787096054899 -1.7161000000000002 0.7051926640319901 0.705190964321661 -8.300277310174103e-08 -0.09891819791304779 -1.7162 0.7051932429186163 0.7051915441769203 -8.756560744387076e-08 -0.09891852476729886 -1.7163000000000002 0.7051938215819232 0.7051921239063498 -9.21168582688689e-08 -0.0989188515233314 -1.7164000000000001 0.7051944000221 0.7051927035098644 -9.665548440524613e-08 -0.09891917818117457 -1.7165 0.7051949782393465 0.7051932829873686 -1.011804478881495e-07 -0.09891950474085756 -1.7166000000000001 0.7051955562338741 0.7051938623387553 -1.0569071419615217e-07 -0.09891983120240955 -1.7167000000000001 0.7051961340059048 0.7051944415639066 -1.101852524724306e-07 -0.0989201575658597 -1.7168 0.7051967115556719 0.7051950206626936 -1.1466303578670789e-07 -0.09892048383123714 -1.7169 0.7051972888834195 0.7051955996349766 -1.1912304133734897e-07 -0.09892080999857107 -1.717 0.7051978659894025 0.7051961784806045 -1.2356425071503863e-07 -0.09892113606789062 -1.7171 0.7051984428738867 0.7051967571994155 -1.2798565012656082e-07 -0.09892146203922488 -1.7172 0.7051990195371489 0.7051973357912377 -1.3238623060470023e-07 -0.09892178791260305 -1.7173000000000003 0.7051995959794762 0.7051979142558872 -1.3676498828232853e-07 -0.09892211368805416 -1.7174 0.705200172201167 0.70519849259317 -1.4112092455720315e-07 -0.09892243936560736 -1.7175 0.7052007482025295 0.7051990708028818 -1.4545304640421752e-07 -0.09892276494529172 -1.7176000000000002 0.7052013239838832 0.7051996488848071 -1.4976036651938307e-07 -0.09892309042713633 -1.7177 0.705201899545558 0.7052002268387205 -1.54041903597385e-07 -0.09892341581117035 -1.7178000000000002 0.7052024748878936 0.7052008046643855 -1.582966825276061e-07 -0.09892374109742276 -1.7179 0.7052030500112405 0.7052013823615557 -1.6252373463525316e-07 -0.09892406628592265 -1.718 0.7052036249159594 0.705201959929974 -1.667220978912587e-07 -0.09892439137669908 -1.7181000000000002 0.7052041996024216 0.7052025373693735 -1.708908171343254e-07 -0.09892471636978108 -1.7182 0.7052047740710079 0.7052031146794766 -1.75028944286032e-07 -0.09892504126519769 -1.7183000000000002 0.7052053483221097 0.705203691859996 -1.7913553855899988e-07 -0.09892536606297797 -1.7184000000000001 0.7052059223561277 0.7052042689106347 -1.832096667014893e-07 -0.0989256907631509 -1.7185 0.7052064961734732 0.705204845831085 -1.872504031413813e-07 -0.09892601536574552 -1.7186000000000001 0.705207069774567 0.7052054226210298 -1.912568303140405e-07 -0.09892633987079084 -1.7187000000000001 0.7052076431598397 0.7052059992801423 -1.9522803873170402e-07 -0.09892666427831583 -1.7188 0.7052082163297313 0.7052065758080859 -1.9916312728532337e-07 -0.0989269885883495 -1.7189 0.7052087892846914 0.7052071522045145 -2.0306120342150624e-07 -0.09892731280092076 -1.719 0.7052093620251794 0.7052077284690723 -2.069213833263972e-07 -0.09892763691605867 -1.7191 0.7052099345516636 0.7052083046013948 -2.1074279218241676e-07 -0.09892796093379216 -1.7192 0.7052105068646219 0.7052088806011076 -2.1452456427928368e-07 -0.09892828485415023 -1.7193000000000003 0.705211078964541 0.7052094564678271 -2.1826584328810128e-07 -0.09892860867716173 -1.7194 0.7052116508519168 0.7052100322011607 -2.2196578242442144e-07 -0.09892893240285562 -1.7195 0.7052122225272544 0.7052106078007074 -2.2562354461130862e-07 -0.09892925603126088 -1.7196000000000002 0.7052127939910671 0.7052111832660566 -2.2923830275342616e-07 -0.09892957956240642 -1.7197 0.7052133652438777 0.7052117585967892 -2.3280923980295576e-07 -0.09892990299632112 -1.7198000000000002 0.7052139362862169 0.7052123337924776 -2.3633554905796994e-07 -0.0989302263330339 -1.7199 0.7052145071186244 0.7052129088526853 -2.3981643429080157e-07 -0.09893054957257365 -1.72 0.7052150777416482 0.7052134837769681 -2.4325110990069954e-07 -0.09893087271496927 -1.7201000000000002 0.7052156481558445 0.7052140585648724 -2.466388011705678e-07 -0.09893119576024961 -1.7202 0.7052162183617773 0.7052146332159377 -2.4997874435023215e-07 -0.09893151870844358 -1.7203000000000002 0.7052167883600191 0.7052152077296943 -2.5327018689583203e-07 -0.09893184155957999 -1.7204000000000002 0.7052173581511502 0.7052157821056653 -2.565123876224762e-07 -0.0989321643136877 -1.7205 0.7052179277357589 0.7052163563433655 -2.5970461683955115e-07 -0.09893248697079558 -1.7206000000000001 0.7052184971144405 0.7052169304423026 -2.628461565831741e-07 -0.09893280953093248 -1.7207000000000001 0.7052190662877986 0.7052175044019762 -2.659363006890514e-07 -0.09893313199412723 -1.7208 0.7052196352564437 0.7052180782218784 -2.689743550249313e-07 -0.09893345436040858 -1.7209 0.7052202040209938 0.7052186519014946 -2.7195963762244313e-07 -0.0989337766298054 -1.721 0.7052207725820739 0.7052192254403027 -2.748914787950585e-07 -0.09893409880234649 -1.7211 0.7052213409403161 0.7052197988377729 -2.777692213427885e-07 -0.09893442087806059 -1.7212 0.7052219090963594 0.7052203720933699 -2.8059222068055334e-07 -0.09893474285697658 -1.7213000000000003 0.7052224770508497 0.7052209452065504 -2.8335984495614364e-07 -0.0989350647391232 -1.7214 0.705223044804439 0.7052215181767651 -2.860714752341009e-07 -0.09893538652452917 -1.7215 0.705223612357786 0.705222091003458 -2.887265056102095e-07 -0.09893570821322328 -1.7216000000000002 0.7052241797115557 0.7052226636860667 -2.91324343339866e-07 -0.0989360298052343 -1.7217 0.7052247468664198 0.7052232362240227 -2.938644089733877e-07 -0.09893635130059095 -1.7218000000000002 0.7052253138230553 0.7052238086167516 -2.963461365260156e-07 -0.09893667269932198 -1.7219 0.7052258805821452 0.705224380863673 -2.98768973523017e-07 -0.09893699400145614 -1.722 0.7052264471443785 0.7052249529642003 -3.0113238119744423e-07 -0.09893731520702209 -1.7221000000000002 0.7052270135104499 0.7052255249177417 -3.034358345907484e-07 -0.0989376363160486 -1.7222 0.7052275796810591 0.7052260967237001 -3.056788226291074e-07 -0.09893795732856432 -1.7223000000000002 0.7052281456569113 0.7052266683814725 -3.0786084827955085e-07 -0.09893827824459797 -1.7224000000000002 0.705228711438717 0.7052272398904513 -3.0998142869220757e-07 -0.09893859906417826 -1.7225 0.7052292770271915 0.7052278112500234 -3.120400952003055e-07 -0.09893891978733382 -1.7226000000000001 0.7052298424230548 0.7052283824595714 -3.140363934867052e-07 -0.09893924041409333 -1.7227000000000001 0.7052304076270317 0.7052289535184729 -3.1596988373655543e-07 -0.09893956094448547 -1.7228 0.7052309726398518 0.7052295244261009 -3.1784014065810995e-07 -0.09893988137853887 -1.7229 0.7052315374622489 0.7052300951818238 -3.1964675357987193e-07 -0.09894020171628222 -1.723 0.7052321020949606 0.705230665785006 -3.2138932656855523e-07 -0.0989405219577441 -1.7231 0.705232666538729 0.7052312362350082 -3.2306747852622886e-07 -0.09894084210295313 -1.7232 0.7052332307943001 0.7052318065311864 -3.2468084323888924e-07 -0.09894116215193799 -1.7233000000000003 0.7052337948624234 0.7052323766728936 -3.262290694458492e-07 -0.09894148210472725 -1.7234 0.7052343587438521 0.7052329466594786 -3.277118210062713e-07 -0.09894180196134955 -1.7235 0.7052349224393428 0.705233516490287 -3.291287768436568e-07 -0.0989421217218334 -1.7236000000000002 0.705235485949655 0.7052340861646614 -3.3047963108462364e-07 -0.09894244138620747 -1.7237 0.7052360492755518 0.7052346556819409 -3.317640931699284e-07 -0.09894276095450028 -1.7238000000000002 0.7052366124177993 0.7052352250414617 -3.329818878197721e-07 -0.09894308042674047 -1.7239 0.7052371753771656 0.7052357942425573 -3.3413275516563923e-07 -0.09894339980295647 -1.724 0.7052377381544219 0.7052363632845593 -3.352164507225419e-07 -0.09894371908317698 -1.7241000000000002 0.7052383007503419 0.7052369321667953 -3.3623274559024807e-07 -0.09894403826743048 -1.7242 0.7052388631657014 0.7052375008885918 -3.371814263214423e-07 -0.09894435735574553 -1.7243000000000002 0.7052394254012778 0.705238069449273 -3.3806229509519836e-07 -0.0989446763481506 -1.7244000000000002 0.7052399874578514 0.7052386378481609 -3.3887516971697895e-07 -0.09894499524467423 -1.7245 0.7052405493362035 0.705239206084576 -3.396198836325137e-07 -0.09894531404534498 -1.7246000000000001 0.7052411110371172 0.7052397741578369 -3.402962859971881e-07 -0.0989456327501913 -1.7247000000000001 0.7052416725613772 0.705240342067261 -3.409042416760433e-07 -0.09894595135924172 -1.7248 0.705242233909769 0.7052409098121644 -3.4144363129234856e-07 -0.0989462698725247 -1.7249 0.7052427950830795 0.7052414773918618 -3.4191435126923464e-07 -0.09894658829006872 -1.725 0.7052433560820967 0.7052420448056675 -3.423163137741825e-07 -0.09894690661190227 -1.7251 0.7052439169076086 0.7052426120528945 -3.426494468439234e-07 -0.09894722483805375 -1.7252 0.7052444775604048 0.7052431791328557 -3.429136942803557e-07 -0.09894754296855174 -1.7253000000000003 0.705245038041274 0.7052437460448631 -3.4310901571993346e-07 -0.09894786100342454 -1.7254 0.7052455983510064 0.7052443127882286 -3.432353866822391e-07 -0.09894817894270065 -1.7255 0.7052461584903914 0.7052448793622643 -3.4329279849365513e-07 -0.09894849678640849 -1.7256000000000002 0.7052467184602188 0.705245445766282 -3.4328125829430345e-07 -0.09894881453457649 -1.7257 0.705247278261278 0.7052460119995944 -3.4320078906580065e-07 -0.0989491321872331 -1.7258000000000002 0.7052478378943574 0.7052465780615136 -3.4305142961044144e-07 -0.09894944974440664 -1.7259 0.7052483973602457 0.705247143951353 -3.4283323453732084e-07 -0.09894976720612557 -1.726 0.7052489566597299 0.7052477096684266 -3.425462742415175e-07 -0.09895008457241823 -1.7261000000000002 0.7052495157935967 0.7052482752120495 -3.421906348485826e-07 -0.09895040184331305 -1.7262 0.7052500747626314 0.7052488405815374 -3.4176641823535636e-07 -0.09895071901883831 -1.7263000000000002 0.7052506335676181 0.705249405776208 -3.412737420369072e-07 -0.09895103609902248 -1.7264000000000002 0.7052511922093394 0.7052499707953798 -3.407127395355092e-07 -0.09895135308389387 -1.7265 0.705251750688576 0.7052505356383731 -3.400835596606422e-07 -0.0989516699734808 -1.7266000000000001 0.7052523090061074 0.7052511003045103 -3.3938636694041957e-07 -0.09895198676781164 -1.7267000000000001 0.7052528671627105 0.7052516647931153 -3.386213414738326e-07 -0.09895230346691469 -1.7268000000000001 0.7052534251591607 0.7052522291035139 -3.3778867888217823e-07 -0.09895262007081831 -1.7269 0.7052539829962303 0.7052527932350352 -3.368885902535479e-07 -0.09895293657955082 -1.727 0.7052545406746897 0.7052533571870095 -3.35921302115072e-07 -0.09895325299314045 -1.7271 0.7052550981953066 0.7052539209587706 -3.3488705631495863e-07 -0.09895356931161553 -1.7272 0.7052556555588461 0.7052544845496547 -3.337861100155548e-07 -0.0989538855350044 -1.7273000000000003 0.7052562127660695 0.7052550479590007 -3.326187356308963e-07 -0.09895420166333525 -1.7274 0.7052567698177361 0.705255611186151 -3.3138522070874643e-07 -0.09895451769663643 -1.7275 0.7052573267146012 0.7052561742304511 -3.300858679514129e-07 -0.09895483363493612 -1.7276000000000002 0.7052578834574169 0.7052567370912498 -3.2872099503533647e-07 -0.09895514947826269 -1.7277 0.7052584400469317 0.7052572997678996 -3.272909346180297e-07 -0.09895546522664428 -1.7278000000000002 0.7052589964838905 0.705257862259757 -3.2579603419236047e-07 -0.0989557808801092 -1.7279 0.7052595527690335 0.7052584245661817 -3.2423665605879615e-07 -0.09895609643868566 -1.728 0.7052601089030979 0.7052589866865382 -3.2261317720050364e-07 -0.09895641190240188 -1.7281000000000002 0.7052606648868158 0.7052595486201945 -3.209259892208993e-07 -0.09895672727128606 -1.7282 0.7052612207209155 0.7052601103665235 -3.191754982048711e-07 -0.09895704254536639 -1.7283000000000002 0.7052617764061206 0.7052606719249024 -3.173621246979619e-07 -0.0989573577246711 -1.7284000000000002 0.7052623319431501 0.7052612332947129 -3.154863035120803e-07 -0.09895767280922839 -1.7285 0.7052628873327176 0.7052617944753419 -3.1354848367692867e-07 -0.0989579877990664 -1.7286000000000001 0.7052634425755322 0.705262355466181 -3.115491283359195e-07 -0.09895830269421332 -1.7287000000000001 0.705263997672298 0.705262916266627 -3.094887146073977e-07 -0.09895861749469734 -1.7288000000000001 0.7052645526237133 0.7052634768760817 -3.0736773351525137e-07 -0.09895893220054658 -1.7289 0.7052651074304713 0.7052640372939529 -3.0518668978074537e-07 -0.09895924681178919 -1.729 0.7052656620932594 0.7052645975196534 -3.029461018641544e-07 -0.09895956132845332 -1.7291 0.7052662166127598 0.7052651575526021 -3.006465016733295e-07 -0.09895987575056713 -1.7292 0.7052667709896479 0.7052657173922238 -2.9828843452553433e-07 -0.0989601900781587 -1.7293000000000003 0.705267325224594 0.7052662770379485 -2.958724589739725e-07 -0.09896050431125619 -1.7294 0.7052678793182614 0.7052668364892132 -2.933991467488073e-07 -0.09896081844988763 -1.7295 0.705268433271308 0.7052673957454607 -2.9086908252470844e-07 -0.09896113249408121 -1.7296 0.7052689870843845 0.7052679548061407 -2.88282863879219e-07 -0.09896144644386495 -1.7297 0.7052695407581354 0.7052685136707089 -2.856411010776494e-07 -0.09896176029926702 -1.7298000000000002 0.7052700942931984 0.7052690723386279 -2.8294441696552486e-07 -0.09896207406031539 -1.7299 0.7052706476902042 0.7052696308093671 -2.801934468159295e-07 -0.09896238772703816 -1.73 0.705271200949777 0.7052701890824027 -2.773888381872591e-07 -0.09896270129946338 -1.7301000000000002 0.7052717540725335 0.7052707471572184 -2.7453125074280993e-07 -0.09896301477761915 -1.7302 0.7052723070590834 0.7052713050333047 -2.7162135613281735e-07 -0.09896332816153351 -1.7303000000000002 0.7052728599100287 0.7052718627101597 -2.6865983780363645e-07 -0.09896364145123449 -1.7304000000000002 0.7052734126259643 0.7052724201872885 -2.6564739084508626e-07 -0.09896395464675006 -1.7305 0.7052739652074773 0.7052729774642041 -2.625847218586108e-07 -0.09896426774810824 -1.7306000000000001 0.705274517655147 0.7052735345404275 -2.594725487491123e-07 -0.09896458075533712 -1.7307000000000001 0.7052750699695449 0.705274091415487 -2.5631160060352043e-07 -0.09896489366846462 -1.7308000000000001 0.7052756221512348 0.7052746480889189 -2.531026174444617e-07 -0.09896520648751878 -1.7309 0.705276174200772 0.7052752045602677 -2.498463501435233e-07 -0.09896551921252753 -1.731 0.7052767261187044 0.7052757608290859 -2.465435601818611e-07 -0.09896583184351891 -1.7311 0.7052772779055704 0.7052763168949346 -2.4319501953223854e-07 -0.09896614438052084 -1.7312 0.7052778295619011 0.705276872757383 -2.3980151041963493e-07 -0.09896645682356134 -1.7313000000000003 0.705278381088218 0.7052774284160087 -2.363638251651201e-07 -0.09896676917266826 -1.7314 0.7052789324850353 0.7052779838703984 -2.32882765995035e-07 -0.09896708142786968 -1.7315 0.7052794837528571 0.7052785391201467 -2.2935914488139697e-07 -0.09896739358919339 -1.7316 0.70528003489218 0.7052790941648579 -2.2579378329903865e-07 -0.09896770565666746 -1.7317 0.7052805859034903 0.7052796490041445 -2.2218751208682996e-07 -0.09896801763031968 -1.7318000000000002 0.7052811367872664 0.7052802036376284 -2.1854117120481686e-07 -0.09896832951017806 -1.7319 0.705281687543977 0.7052807580649403 -2.1485560959544348e-07 -0.09896864129627042 -1.732 0.7052822381740818 0.7052813122857204 -2.1113168494416024e-07 -0.09896895298862474 -1.7321000000000002 0.7052827886780311 0.7052818662996179 -2.0737026349554322e-07 -0.09896926458726889 -1.7322 0.7052833390562656 0.7052824201062917 -2.0357221982778007e-07 -0.0989695760922307 -1.7323000000000002 0.705283889309217 0.7052829737054098 -1.9973843670695324e-07 -0.09896988750353808 -1.7324000000000002 0.705284439437307 0.7052835270966498 -1.958698048060148e-07 -0.09897019882121885 -1.7325 0.7052849894409479 0.7052840802796989 -1.919672225660085e-07 -0.0989705100453009 -1.7326000000000001 0.7052855393205419 0.7052846332542546 -1.8803159595667807e-07 -0.09897082117581209 -1.7327000000000001 0.705286089076482 0.7052851860200233 -1.8406383825095296e-07 -0.0989711322127802 -1.7328000000000001 0.7052866387091508 0.7052857385767219 -1.800648698306595e-07 -0.09897144315623313 -1.7329 0.7052871882189211 0.7052862909240769 -1.7603561799917067e-07 -0.09897175400619869 -1.733 0.7052877376061558 0.705286843061825 -1.719770167142587e-07 -0.09897206476270469 -1.7331 0.7052882868712074 0.7052873949897127 -1.678900064215616e-07 -0.09897237542577891 -1.7332 0.7052888360144185 0.7052879467074968 -1.6377553377702747e-07 -0.09897268599544914 -1.7333000000000003 0.705289385036121 0.7052884982149444 -1.5963455150293238e-07 -0.0989729964717432 -1.7334 0.7052899339366376 0.7052890495118329 -1.554680180947121e-07 -0.09897330685468889 -1.7335 0.7052904827162796 0.7052896005979499 -1.512768976578982e-07 -0.09897361714431396 -1.7336 0.7052910313753482 0.7052901514730929 -1.4706215964443992e-07 -0.09897392734064618 -1.7337 0.7052915799141339 0.7052907021370708 -1.4282477865147636e-07 -0.09897423744371327 -1.7338000000000002 0.7052921283329172 0.7052912525897024 -1.3856573418367935e-07 -0.09897454745354303 -1.7339 0.7052926766319678 0.705291802830817 -1.3428601043988242e-07 -0.09897485737016319 -1.734 0.7052932248115447 0.7052923528602548 -1.2998659607021956e-07 -0.09897516719360146 -1.7341000000000002 0.705293772871896 0.7052929026778665 -1.2566848396101948e-07 -0.09897547692388559 -1.7342 0.7052943208132598 0.7052934522835134 -1.2133267099194434e-07 -0.0989757865610433 -1.7343000000000002 0.7052948686358629 0.7052940016770675 -1.1698015782261872e-07 -0.09897609610510233 -1.7344000000000002 0.7052954163399213 0.7052945508584114 -1.1261194864629898e-07 -0.09897640555609027 -1.7345 0.7052959639256404 0.705295099827439 -1.0822905096956326e-07 -0.09897671491403487 -1.7346000000000001 0.7052965113932147 0.7052956485840545 -1.0383247537031765e-07 -0.09897702417896385 -1.7347000000000001 0.7052970587428278 0.7052961971281734 -9.942323527835362e-08 -0.09897733335090486 -1.7348000000000001 0.7052976059746525 0.7052967454597217 -9.500234672641522e-08 -0.09897764242988555 -1.7349 0.7052981530888507 0.7052972935786362 -9.057082812641976e-08 -0.09897795141593363 -1.735 0.705298700085573 0.7052978414848653 -8.612970003613746e-08 -0.09897826030907672 -1.7351 0.7052992469649593 0.7052983891783675 -8.167998490852396e-08 -0.09897856910934241 -1.7352 0.7052997937271385 0.7052989366591127 -7.722270687921667e-08 -0.09897887781675843 -1.7353000000000003 0.7053003403722284 0.7052994839270823 -7.275889151586723e-08 -0.0989791864313524 -1.7354 0.705300886900336 0.7053000309822675 -6.828956558568855e-08 -0.09897949495315188 -1.7355 0.7053014333115568 0.7053005778246715 -6.38157568182314e-08 -0.09897980338218454 -1.7356 0.7053019796059761 0.7053011244543078 -5.9338493673798814e-08 -0.09898011171847794 -1.7357 0.7053025257836669 0.7053016708712017 -5.485880510036796e-08 -0.09898041996205972 -1.7358000000000002 0.7053030718446924 0.7053022170753886 -5.037772030677505e-08 -0.09898072811295738 -1.7359 0.7053036177891041 0.7053027630669157 -4.589626851237306e-08 -0.09898103617119863 -1.736 0.7053041636169426 0.7053033088458409 -4.141547872411975e-08 -0.09898134413681096 -1.7361000000000002 0.7053047093282376 0.705303854412233 -3.693637949328272e-08 -0.09898165200982195 -1.7362 0.7053052549230077 0.7053043997661719 -3.245999868092646e-08 -0.0989819597902592 -1.7363000000000002 0.70530580040126 0.7053049449077484 -2.7987363223399425e-08 -0.0989822674781502 -1.7364000000000002 0.7053063457629911 0.7053054898370645 -2.351949889446009e-08 -0.09898257507352244 -1.7365 0.705306891008187 0.705306034554233 -1.9057430072390302e-08 -0.09898288257640359 -1.7366000000000001 0.7053074361368219 0.7053065790593777 -1.4602179503313967e-08 -0.09898318998682107 -1.7367000000000001 0.7053079811488594 0.7053071233526332 -1.0154768068093567e-08 -0.09898349730480244 -1.7368000000000001 0.705308526044252 0.7053076674341452 -5.7162145494435435e-09 -0.09898380453037518 -1.7369 0.7053090708229419 0.7053082113040703 -1.2875353934058142e-09 -0.09898411166356685 -1.737 0.7053096154848598 0.7053087549625754 3.1302555157305956e-09 -0.09898441870440489 -1.7371 0.7053101600299256 0.7053092984098388 7.536147090918266e-09 -0.09898472565291676 -1.7372 0.7053107044580487 0.7053098416460495 1.1929131274804328e-08 -0.09898503250912996 -1.7373000000000003 0.7053112487691274 0.7053103846714072 1.630820327391813e-08 -0.09898533927307196 -1.7374 0.7053117929630498 0.7053109274861221 2.067236177464432e-08 -0.09898564594477027 -1.7375 0.7053123370396925 0.7053114700904153 2.5020609190420928e-08 -0.09898595252425227 -1.7376 0.7053128809989222 0.7053120124845188 2.9351951875977722e-08 -0.09898625901154548 -1.7377 0.7053134248405942 0.7053125546686744 3.366540035805443e-08 -0.09898656540667723 -1.7378000000000002 0.7053139685645542 0.705313096643135 3.795996956351688e-08 -0.09898687170967505 -1.7379 0.7053145121706365 0.7053136384081639 4.223467904226896e-08 -0.09898717792056627 -1.738 0.7053150556586655 0.7053141799640348 4.648855319797085e-08 -0.09898748403937835 -1.7381000000000002 0.705315599028455 0.7053147213110318 5.072062150140999e-08 -0.09898779006613873 -1.7382 0.7053161422798084 0.7053152624494492 5.4929918709076264e-08 -0.09898809600087476 -1.7383000000000002 0.705316685412519 0.7053158033795921 5.911548509214548e-08 -0.09898840184361382 -1.7384000000000002 0.7053172284263693 0.7053163441017748 6.327636664811565e-08 -0.0989887075943833 -1.7385 0.7053177713211327 0.7053168846163225 6.741161533499462e-08 -0.09898901325321058 -1.7386000000000001 0.7053183140965715 0.7053174249235703 7.15202892673239e-08 -0.09898931882012302 -1.7387000000000001 0.7053188567524382 0.7053179650238632 7.560145293301901e-08 -0.09898962429514796 -1.7388000000000001 0.705319399288476 0.7053185049175565 7.965417742235303e-08 -0.09898992967831279 -1.7389000000000001 0.7053199417044175 0.7053190446050148 8.367754061010257e-08 -0.09899023496964487 -1.739 0.7053204839999855 0.7053195840866127 8.76706273966743e-08 -0.09899054016917143 -1.7391 0.7053210261748932 0.7053201233627344 9.163252989025095e-08 -0.09899084527691986 -1.7392 0.7053215682288445 0.7053206624337744 9.556234765312199e-08 -0.09899115029291748 -1.7393000000000003 0.7053221101615332 0.7053212013001359 9.945918785433938e-08 -0.09899145521719159 -1.7394 0.7053226519726439 0.705321739962232 1.0332216550737461e-07 -0.0989917600497695 -1.7395 0.7053231936618518 0.7053222784204847 1.0715040364359107e-07 -0.09899206479067849 -1.7396 0.7053237352288229 0.7053228166753258 1.1094303354469703e-07 -0.09899236943994583 -1.7397 0.7053242766732133 0.7053233547271964 1.1469919491968739e-07 -0.09899267399759881 -1.7398000000000002 0.705324817994671 0.7053238925765462 1.1841803610260215e-07 -0.09899297846366473 -1.7399 0.705325359192834 0.7053244302238342 1.2209871425722385e-07 -0.0989932828381708 -1.74 0.7053259002673323 0.7053249676695277 1.257403955193248e-07 -0.09899358712114427 -1.7401000000000002 0.7053264412177862 0.7053255049141038 1.2934225527422294e-07 -0.09899389131261242 -1.7402 0.705326982043808 0.705326041958048 1.3290347826433457e-07 -0.0989941954126025 -1.7403000000000002 0.7053275227450007 0.7053265788018541 1.3642325881121908e-07 -0.0989944994211417 -1.7404000000000002 0.7053280633209591 0.7053271154460246 1.3990080097517343e-07 -0.09899480333825725 -1.7405 0.7053286037712696 0.70532765189107 1.43335318763399e-07 -0.09899510716397636 -1.7406000000000001 0.7053291440955103 0.70532818813751 1.4672603628612668e-07 -0.09899541089832627 -1.7407000000000001 0.7053296842932508 0.7053287241858714 1.500721879266198e-07 -0.09899571454133411 -1.7408000000000001 0.7053302243640533 0.70532926003669 1.5337301855281038e-07 -0.09899601809302716 -1.7409000000000001 0.7053307643074712 0.7053297956905087 1.5662778362832142e-07 -0.09899632155343252 -1.741 0.7053313041230505 0.7053303311478789 1.598357494483893e-07 -0.09899662492257738 -1.7411 0.7053318438103295 0.7053308664093594 1.6299619323700831e-07 -0.09899692820048898 -1.7412 0.7053323833688386 0.7053314014755165 1.661084033724447e-07 -0.09899723138719435 -1.7413000000000003 0.7053329227981008 0.7053319363469246 1.6917167947050338e-07 -0.09899753448272075 -1.7414 0.7053334620976317 0.7053324710241644 1.72185332641267e-07 -0.09899783748709523 -1.7415 0.70533400126694 0.7053330055078249 1.7514868555848495e-07 -0.09899814040034502 -1.7416 0.7053345403055269 0.7053335397985017 1.7806107265733173e-07 -0.09899844322249723 -1.7417 0.7053350792128863 0.7053340738967969 1.8092184025930713e-07 -0.0989987459535789 -1.7418000000000002 0.7053356179885061 0.7053346078033205 1.8373034673183075e-07 -0.09899904859361723 -1.7419 0.7053361566318666 0.7053351415186881 1.8648596265477546e-07 -0.09899935114263925 -1.742 0.7053366951424418 0.7053356750435229 1.8918807090720358e-07 -0.09899965360067205 -1.7421000000000002 0.7053372335196995 0.7053362083784538 1.9183606683736976e-07 -0.09899995596774278 -1.7422 0.7053377717631006 0.7053367415241163 1.9442935842231557e-07 -0.09900025824387845 -1.7423000000000002 0.7053383098721007 0.7053372744811522 1.969673663511362e-07 -0.09900056042910621 -1.7424000000000002 0.7053388478461483 0.705337807250209 1.9944952417416673e-07 -0.09900086252345303 -1.7425 0.7053393856846868 0.7053383398319406 2.018752784486988e-07 -0.09900116452694607 -1.7426000000000001 0.705339923387153 0.7053388722270061 2.0424408883612521e-07 -0.09900146643961232 -1.7427000000000001 0.7053404609529788 0.7053394044360706 2.0655542823377893e-07 -0.09900176826147881 -1.7428000000000001 0.7053409983815903 0.7053399364598043 2.0880878288595528e-07 -0.09900206999257258 -1.7429000000000001 0.705341535672408 0.7053404682988831 2.1100365251575104e-07 -0.09900237163292062 -1.743 0.7053420728248478 0.7053409999539881 2.1313955038404497e-07 -0.09900267318255003 -1.7431 0.70534260983832 0.7053415314258051 2.1521600347337855e-07 -0.09900297464148776 -1.7432 0.7053431467122303 0.7053420627150253 2.1723255255040597e-07 -0.09900327600976087 -1.7433 0.7053436834459793 0.7053425938223437 2.1918875228038592e-07 -0.09900357728739624 -1.7434 0.7053442200389632 0.705343124748461 2.2108417126187607e-07 -0.09900387847442094 -1.7435 0.7053447564905739 0.7053436554940815 2.2291839225918597e-07 -0.09900417957086192 -1.7436 0.7053452928001988 0.7053441860599143 2.2469101217115206e-07 -0.09900448057674616 -1.7437 0.7053458289672208 0.7053447164466724 2.264016421144044e-07 -0.09900478149210058 -1.7438000000000002 0.7053463649910194 0.7053452466550729 2.2804990761765564e-07 -0.09900508231695217 -1.7439 0.7053469008709701 0.7053457766858364 2.2963544861476226e-07 -0.09900538305132789 -1.744 0.7053474366064443 0.7053463065396877 2.3115791955574672e-07 -0.09900568369525464 -1.7441000000000002 0.7053479721968103 0.7053468362173547 2.3261698948312537e-07 -0.09900598424875934 -1.7442 0.7053485076414329 0.7053473657195688 2.3401234204578625e-07 -0.09900628471186897 -1.7443000000000002 0.7053490429396735 0.7053478950470645 2.3534367570021697e-07 -0.09900658508461035 -1.7444000000000002 0.7053495780908907 0.7053484242005797 2.3661070358560465e-07 -0.09900688536701052 -1.7445 0.7053501130944402 0.7053489531808548 2.3781315380139167e-07 -0.0990071855590963 -1.7446000000000002 0.7053506479496745 0.7053494819886326 2.3895076925462e-07 -0.09900748566089454 -1.7447000000000001 0.705351182655944 0.7053500106246593 2.400233078958536e-07 -0.09900778567243218 -1.7448000000000001 0.7053517172125965 0.7053505390896826 2.41030542677545e-07 -0.09900808559373603 -1.7449000000000001 0.7053522516189774 0.7053510673844535 2.419722615332187e-07 -0.09900838542483303 -1.745 0.7053527858744306 0.705351595509724 2.428482676203325e-07 -0.09900868516575001 -1.7451 0.7053533199782971 0.705352123466249 2.436583791606828e-07 -0.0990089848165138 -1.7452 0.7053538539299169 0.7053526512547842 2.4440242958612135e-07 -0.09900928437715129 -1.7453 0.7053543877286279 0.7053531788760874 2.450802675593722e-07 -0.09900958384768928 -1.7454 0.7053549213737671 0.7053537063309178 2.4569175696709245e-07 -0.0990098832281546 -1.7455 0.7053554548646697 0.7053542336200356 2.462367769962004e-07 -0.09901018251857405 -1.7456 0.7053559882006698 0.7053547607442027 2.4671522211305863e-07 -0.09901048171897449 -1.7457 0.705356521381101 0.705355287704181 2.4712700207735194e-07 -0.09901078082938268 -1.7458000000000002 0.7053570544052957 0.7053558145007339 2.4747204207392626e-07 -0.09901107984982543 -1.7459 0.7053575872725857 0.7053563411346256 2.477502825254385e-07 -0.09901137878032956 -1.746 0.7053581199823025 0.7053568676066199 2.47961679265829e-07 -0.09901167762092178 -1.7461000000000002 0.7053586525337772 0.7053573939174815 2.4810620349868806e-07 -0.09901197637162898 -1.7462 0.7053591849263408 0.7053579200679749 2.4818384178337816e-07 -0.09901227503247784 -1.7463000000000002 0.7053597171593241 0.7053584460588646 2.4819459601421734e-07 -0.0990125736034951 -1.7464000000000002 0.7053602492320588 0.7053589718909148 2.481384834829292e-07 -0.09901287208470756 -1.7465 0.7053607811438758 0.7053594975648897 2.4801553681619293e-07 -0.09901317047614189 -1.7466000000000002 0.7053613128941076 0.7053600230815527 2.4782580396870424e-07 -0.09901346877782491 -1.7467000000000001 0.7053618444820868 0.7053605484416661 2.4756934821623666e-07 -0.09901376698978327 -1.7468000000000001 0.705362375907147 0.7053610736459921 2.4724624816951923e-07 -0.09901406511204373 -1.7469000000000001 0.705362907168623 0.7053615986952912 2.468565976840309e-07 -0.099014363144633 -1.747 0.7053634382658505 0.7053621235903234 2.464005058808172e-07 -0.09901466108757773 -1.7471 0.7053639691981666 0.7053626483318465 2.4587809709791797e-07 -0.09901495894090473 -1.7472 0.7053644999649099 0.7053631729206169 2.4528951084873407e-07 -0.09901525670464056 -1.7473 0.7053650305654211 0.70536369735739 2.4463490189141623e-07 -0.09901555437881197 -1.7474 0.7053655609990419 0.7053642216429189 2.439144399790649e-07 -0.09901585196344564 -1.7475 0.7053660912651167 0.7053647457779544 2.43128310012386e-07 -0.0990161494585682 -1.7476 0.7053666213629919 0.7053652697632455 2.422767119147906e-07 -0.09901644686420633 -1.7477 0.7053671512920158 0.7053657935995388 2.413598605283118e-07 -0.09901674418038663 -1.7478000000000002 0.7053676810515397 0.7053663172875781 2.403779856968713e-07 -0.09901704140713578 -1.7479 0.7053682106409171 0.7053668408281052 2.3933133204423473e-07 -0.09901733854448042 -1.748 0.7053687400595046 0.7053673642218585 2.3822015906421745e-07 -0.09901763559244713 -1.7481000000000002 0.7053692693066616 0.7053678874695737 2.3704474096802874e-07 -0.09901793255106256 -1.7482 0.7053697983817507 0.705368410571983 2.3580536661488294e-07 -0.09901822942035331 -1.7483000000000002 0.7053703272841376 0.7053689335298158 2.345023395050605e-07 -0.09901852620034596 -1.7484000000000002 0.7053708560131917 0.705369456343798 2.3313597764806904e-07 -0.09901882289106716 -1.7485 0.7053713845682854 0.7053699790146515 2.317066134863155e-07 -0.09901911949254344 -1.7486000000000002 0.7053719129487956 0.7053705015430948 2.3021459386735055e-07 -0.09901941600480137 -1.7487000000000001 0.7053724411541027 0.7053710239298425 2.2866027989121296e-07 -0.09901971242786761 -1.7488000000000001 0.7053729691835908 0.7053715461756047 2.2704404688961288e-07 -0.09902000876176863 -1.7489000000000001 0.7053734970366488 0.7053720682810882 2.253662842940929e-07 -0.09902030500653107 -1.749 0.7053740247126694 0.7053725902469944 2.2362739551806676e-07 -0.09902060116218137 -1.7491 0.7053745522110502 0.7053731120740208 2.2182779793600282e-07 -0.09902089722874613 -1.7492 0.7053750795311932 0.7053736337628598 2.1996792270301269e-07 -0.0990211932062519 -1.7493 0.705375606672505 0.7053741553141999 2.180482146924012e-07 -0.09902148909472516 -1.7494 0.7053761336343976 0.7053746767287236 2.1606913245403314e-07 -0.09902178489419243 -1.7495 0.7053766604162875 0.7053751980071089 2.1403114796106348e-07 -0.09902208060468023 -1.7496 0.7053771870175969 0.7053757191500285 2.119347466029986e-07 -0.09902237622621507 -1.7497 0.7053777134377535 0.7053762401581496 2.0978042703651e-07 -0.09902267175882346 -1.7498000000000002 0.7053782396761892 0.705376761032134 2.075687010709426e-07 -0.09902296720253181 -1.7499 0.705378765732343 0.7053772817726376 2.0530009356076184e-07 -0.09902326255736665 -1.75 0.7053792916056596 0.7053778023803106 2.0297514223902025e-07 -0.09902355782335447 -1.7501000000000002 0.7053798172955885 0.7053783228557976 2.0059439766878517e-07 -0.09902385300052169 -1.7502 0.7053803428015863 0.7053788431997368 1.9815842300374698e-07 -0.09902414808889477 -1.7503000000000002 0.7053808681231152 0.7053793634127603 1.956677939604634e-07 -0.09902444308850022 -1.7504000000000002 0.7053813932596438 0.7053798834954937 1.9312309861019283e-07 -0.0990247379993644 -1.7505 0.7053819182106472 0.7053804034485566 1.9052493728174968e-07 -0.09902503282151379 -1.7506000000000002 0.705382442975607 0.7053809232725612 1.8787392240537937e-07 -0.09902532755497473 -1.7507000000000001 0.705382967554012 0.7053814429681139 1.8517067838785817e-07 -0.09902562219977377 -1.7508000000000001 0.7053834919453568 0.7053819625358134 1.824158413800403e-07 -0.0990259167559372 -1.7509000000000001 0.7053840161491438 0.7053824819762523 1.7961005928032736e-07 -0.09902621122349148 -1.751 0.7053845401648822 0.7053830012900153 1.767539914224181e-07 -0.09902650560246296 -1.7511 0.7053850639920887 0.7053835204776804 1.738483085440834e-07 -0.0990267998928781 -1.7512 0.7053855876302864 0.7053840395398178 1.7089369255124387e-07 -0.09902709409476318 -1.7513 0.7053861110790067 0.7053845584769907 1.6789083639653923e-07 -0.09902738820814462 -1.7514 0.7053866343377886 0.7053850772897545 1.648404439023865e-07 -0.09902768223304881 -1.7515 0.7053871574061781 0.705385595978657 1.617432296222021e-07 -0.09902797616950204 -1.7516 0.7053876802837292 0.7053861145442382 1.5859991860794898e-07 -0.0990282700175307 -1.7517 0.7053882029700043 0.70538663298703 1.554112463303392e-07 -0.09902856377716111 -1.7518000000000002 0.705388725464573 0.7053871513075565 1.5217795844638116e-07 -0.09902885744841958 -1.7519 0.7053892477670136 0.7053876695063336 1.4890081060162097e-07 -0.09902915103133247 -1.752 0.7053897698769127 0.705388187583869 1.4558056835728417e-07 -0.09902944452592616 -1.7521000000000002 0.7053902917938641 0.705388705540662 1.4221800690925046e-07 -0.09902973793222677 -1.7522 0.7053908135174715 0.7053892233772034 1.3881391092845918e-07 -0.09903003125026077 -1.7523000000000002 0.7053913350473462 0.705389741093976 1.3536907442560087e-07 -0.09903032448005442 -1.7524000000000002 0.7053918563831082 0.7053902586914529 1.3188430052907263e-07 -0.09903061762163391 -1.7525 0.7053923775243864 0.7053907761700993 1.2836040128375026e-07 -0.09903091067502562 -1.7526000000000002 0.7053928984708187 0.7053912935303714 1.247981974948631e-07 -0.09903120364025575 -1.7527000000000001 0.7053934192220512 0.7053918107727167 1.2119851851982721e-07 -0.09903149651735065 -1.7528000000000001 0.7053939397777396 0.7053923278975733 1.175622020739564e-07 -0.09903178930633649 -1.7529000000000001 0.7053944601375485 0.70539284490537 1.138900940569898e-07 -0.09903208200723952 -1.753 0.7053949803011516 0.7053933617965272 1.1018304831023062e-07 -0.09903237462008604 -1.7531 0.7053955002682318 0.7053938785714557 1.0644192647429884e-07 -0.0990326671449023 -1.7532 0.7053960200384812 0.7053943952305566 1.0266759774973933e-07 -0.09903295958171442 -1.7533 0.7053965396116018 0.7053949117742219 9.886093870967172e-08 -0.09903325193054867 -1.7534 0.7053970589873043 0.7053954282028341 9.502283309509307e-08 -0.09903354419143126 -1.7535 0.7053975781653093 0.7053959445167659 9.115417161018047e-08 -0.09903383636438833 -1.7536 0.7053980971453477 0.7053964607163811 8.72558517071853e-08 -0.0990341284494462 -1.7537 0.7053986159271589 0.7053969768020327 8.332877739040956e-08 -0.09903442044663097 -1.7538000000000002 0.7053991345104927 0.7053974927740647 7.937385900110006e-08 -0.0990347123559688 -1.7539 0.7053996528951089 0.7053980086328109 7.539201300754694e-08 -0.09903500417748591 -1.754 0.7054001710807765 0.7053985243785952 7.138416180385576e-08 -0.09903529591120841 -1.7541000000000002 0.7054006890672748 0.7053990400117318 6.735123346361671e-08 -0.09903558755716248 -1.7542 0.7054012068543937 0.705399555532525 6.329416156296286e-08 -0.09903587911537431 -1.7543000000000002 0.7054017244419323 0.7054000709412682 5.921388493944357e-08 -0.09903617058587 -1.7544000000000002 0.7054022418296998 0.7054005862382455 5.5111347487327156e-08 -0.09903646196867566 -1.7545 0.7054027590175163 0.7054011014237306 5.098749793382151e-08 -0.09903675326381747 -1.7546000000000002 0.7054032760052114 0.7054016164979866 4.684328962223372e-08 -0.09903704447132151 -1.7547000000000001 0.7054037927926253 0.7054021314612668 4.267968029339486e-08 -0.0990373355912139 -1.7548000000000001 0.7054043093796086 0.7054026463138137 3.849763186708488e-08 -0.09903762662352072 -1.7549000000000001 0.7054048257660218 0.7054031610558598 3.4298110204375454e-08 -0.09903791756826805 -1.755 0.7054053419517363 0.705403675687627 3.008208489599373e-08 -0.099038208425482 -1.7551 0.7054058579366337 0.7054041902093271 2.585052903680829e-08 -0.09903849919518869 -1.7552 0.705406373720606 0.705404704621161 2.160441901245813e-08 -0.09903878987741417 -1.7553 0.7054068893035554 0.7054052189233191 1.734473425475669e-08 -0.09903908047218447 -1.7554 0.7054074046853955 0.7054057331159814 1.3072457025718742e-08 -0.09903937097952566 -1.7555 0.7054079198660496 0.7054062471993172 8.788572194648459e-09 -0.09903966139946374 -1.7556 0.7054084348454519 0.7054067611734856 4.494067005686442e-09 -0.09903995173202487 -1.7557 0.705408949623547 0.7054072750386345 1.899308479588746e-10 -0.09904024197723499 -1.7558000000000002 0.7054094642002905 0.7054077887949017 -4.122844962130279e-09 -0.09904053213512011 -1.7559 0.7054099785756482 0.705408302442414 -8.443267422025835e-09 -0.09904082220570633 -1.756 0.705410492749597 0.7054088159812875 -1.277034206072919e-08 -0.09904111218901958 -1.7561000000000002 0.7054110067221238 0.7054093294116275 -1.7103073175588068e-08 -0.09904140208508588 -1.7562 0.705411520493227 0.7054098427335295 -2.144046405217273e-08 -0.09904169189393129 -1.7563000000000002 0.7054120340629151 0.7054103559470771 -2.578151720496885e-08 -0.09904198161558171 -1.7564000000000002 0.7054125474312074 0.705410869052344 -3.01252345966032e-08 -0.09904227125006318 -1.7565 0.705413060598134 0.7054113820493924 -3.447061787550075e-08 -0.09904256079740163 -1.7566000000000002 0.7054135735637357 0.7054118949382748 -3.881666859760404e-08 -0.09904285025762305 -1.7567000000000002 0.7054140863280635 0.7054124077190324 -4.31623884598561e-08 -0.0990431396307534 -1.7568000000000001 0.7054145988911795 0.7054129203916955 -4.7506779528641834e-08 -0.09904342891681855 -1.7569000000000001 0.7054151112531571 0.7054134329562842 -5.184884447077733e-08 -0.09904371811584459 -1.757 0.7054156234140793 0.7054139454128076 -5.618758677793968e-08 -0.09904400722785733 -1.7571 0.70541613537404 0.705414457761264 -6.052201100177623e-08 -0.09904429625288275 -1.7572 0.7054166471331443 0.7054149700016417 -6.485112297519025e-08 -0.0990445851909468 -1.7573 0.7054171586915075 0.7054154821339174 -6.917393004322175e-08 -0.09904487404207536 -1.7574 0.7054176700492549 0.7054159941580578 -7.348944129495841e-08 -0.09904516280629427 -1.7575 0.7054181812065239 0.7054165060740187 -7.779666778232747e-08 -0.0990454514836295 -1.7576 0.7054186921634608 0.7054170178817456 -8.209462275254875e-08 -0.0990457400741069 -1.7577 0.7054192029202236 0.7054175295811733 -8.638232187278133e-08 -0.09904602857775238 -1.7578000000000003 0.7054197134769805 0.705418041172226 -9.065878345086709e-08 -0.09904631699459181 -1.7579 0.7054202238339099 0.7054185526548173 -9.492302867255414e-08 -0.09904660532465101 -1.758 0.705420733991201 0.7054190640288509 -9.917408181139842e-08 -0.09904689356795593 -1.7581000000000002 0.7054212439490531 0.7054195752942192 -1.0341097045687975e-07 -0.09904718172453235 -1.7582 0.705421753707676 0.7054200864508049 -1.0763272574598748e-07 -0.09904746979440612 -1.7583000000000002 0.70542226326729 0.70542059749848 -1.1183838256358103e-07 -0.09904775777760307 -1.7584000000000002 0.7054227726281254 0.7054211084371063 -1.1602697978264909e-07 -0.0990480456741491 -1.7585 0.7054232817904227 0.7054216192665355 -1.2019756048115005e-07 -0.09904833348406995 -1.7586000000000002 0.7054237907544326 0.7054221299866088 -1.2434917215017882e-07 -0.09904862120739145 -1.7587000000000002 0.7054242995204166 0.7054226405971572 -1.2848086691427674e-07 -0.09904890884413943 -1.7588000000000001 0.7054248080886454 0.705423151098002 -1.3259170176041501e-07 -0.09904919639433968 -1.7589000000000001 0.7054253164594 0.7054236614889541 -1.3668073874095743e-07 -0.09904948385801797 -1.759 0.7054258246329715 0.7054241717698144 -1.4074704519050074e-07 -0.09904977123520005 -1.7591 0.705426332609661 0.705424681940374 -1.4478969392710261e-07 -0.09905005852591177 -1.7592 0.7054268403897792 0.7054251920004141 -1.488077634951429e-07 -0.09905034573017885 -1.7593 0.705427347973647 0.7054257019497059 -1.528003383440002e-07 -0.0990506328480271 -1.7594 0.7054278553615945 0.7054262117880112 -1.5676650904315748e-07 -0.09905091987948222 -1.7595 0.7054283625539617 0.7054267215150816 -1.607053725059815e-07 -0.09905120682456997 -1.7596 0.7054288695510982 0.7054272311306596 -1.6461603217013399e-07 -0.0990514936833161 -1.7597 0.7054293763533632 0.7054277406344782 -1.6849759822308574e-07 -0.09905178045574638 -1.7598000000000003 0.7054298829611252 0.7054282500262603 -1.7234918779987507e-07 -0.09905206714188643 -1.7599 0.705430389374762 0.7054287593057198 -1.761699251756621e-07 -0.09905235374176204 -1.76 0.7054308955946608 0.7054292684725615 -1.7995894196001783e-07 -0.0990526402553989 -1.7601000000000002 0.705431401621218 0.7054297775264808 -1.8371537731723397e-07 -0.09905292668282274 -1.7602 0.7054319074548392 0.7054302864671638 -1.8743837814499953e-07 -0.0990532130240592 -1.7603000000000002 0.7054324130959386 0.7054307952942874 -1.9112709925828142e-07 -0.09905349927913397 -1.7604000000000002 0.7054329185449402 0.7054313040075203 -1.9478070360789967e-07 -0.0990537854480728 -1.7605 0.7054334238022759 0.7054318126065213 -1.9839836245053033e-07 -0.09905407153090127 -1.7606000000000002 0.7054339288683869 0.7054323210909412 -2.0197925555687224e-07 -0.09905435752764503 -1.7607000000000002 0.705434433743723 0.7054328294604219 -2.055225713538944e-07 -0.09905464343832986 -1.7608000000000001 0.7054349384287428 0.7054333377145962 -2.090275071572889e-07 -0.09905492926298128 -1.7609000000000001 0.7054354429239127 0.705433845853089 -2.1249326934147383e-07 -0.099055215001625 -1.761 0.7054359472297085 0.7054343538755168 -2.1591907348877948e-07 -0.09905550065428667 -1.7611 0.7054364513466129 0.7054348617814874 -2.193041446149624e-07 -0.09905578622099187 -1.7612 0.7054369552751181 0.7054353695706006 -2.2264771730104438e-07 -0.0990560717017662 -1.7613 0.7054374590157236 0.7054358772424478 -2.259490358945404e-07 -0.0990563570966353 -1.7614 0.7054379625689374 0.7054363847966132 -2.2920735465864484e-07 -0.09905664240562478 -1.7615 0.7054384659352746 0.7054368922326723 -2.3242193795958155e-07 -0.09905692762876023 -1.7616 0.7054389691152588 0.705437399550193 -2.3559206042272907e-07 -0.09905721276606717 -1.7617 0.7054394721094208 0.7054379067487363 -2.38717007099154e-07 -0.09905749781757132 -1.7618000000000003 0.7054399749182992 0.7054384138278544 -2.417960736390834e-07 -0.09905778278329813 -1.7619 0.7054404775424398 0.705438920787093 -2.4482856641680484e-07 -0.09905806766327324 -1.762 0.7054409799823957 0.7054394276259902 -2.4781380271107767e-07 -0.09905835245752222 -1.7621000000000002 0.7054414822387274 0.7054399343440766 -2.507511108751359e-07 -0.09905863716607052 -1.7622 0.7054419843120018 0.7054404409408763 -2.5363983044771055e-07 -0.09905892178894377 -1.7623000000000002 0.7054424862027936 0.7054409474159059 -2.564793123265019e-07 -0.09905920632616744 -1.7624000000000002 0.7054429879116838 0.7054414537686757 -2.592689189173658e-07 -0.09905949077776713 -1.7625 0.70544348943926 0.705441959998689 -2.620080242557443e-07 -0.0990597751437683 -1.7626000000000002 0.7054439907861166 0.7054424661054424 -2.646960141731991e-07 -0.09906005942419649 -1.7627000000000002 0.7054444919528547 0.7054429720884261 -2.6733228640843376e-07 -0.09906034361907723 -1.7628000000000001 0.7054449929400808 0.7054434779471241 -2.6991625077729675e-07 -0.09906062772843595 -1.7629000000000001 0.7054454937484085 0.7054439836810147 -2.7244732925257864e-07 -0.09906091175229824 -1.763 0.705445994378457 0.7054444892895688 -2.749249561548317e-07 -0.09906119569068948 -1.7631000000000001 0.7054464948308511 0.705444994772253 -2.773485782321672e-07 -0.09906147954363521 -1.7632 0.7054469951062221 0.7054455001285266 -2.797176547990332e-07 -0.0990617633111609 -1.7633 0.7054474952052062 0.7054460053578444 -2.820316578715232e-07 -0.09906204699329196 -1.7634 0.7054479951284456 0.7054465104596552 -2.8429007224717306e-07 -0.09906233059005391 -1.7635 0.7054484948765877 0.7054470154334025 -2.8649239566108653e-07 -0.09906261410147219 -1.7636 0.7054489944502847 0.7054475202785242 -2.8863813887961e-07 -0.09906289752757214 -1.7637 0.7054494938501947 0.7054480249944537 -2.9072682580788545e-07 -0.09906318086837929 -1.7638000000000003 0.7054499930769801 0.7054485295806192 -2.9275799356270893e-07 -0.09906346412391903 -1.7639 0.7054504921313083 0.7054490340364439 -2.947311926702889e-07 -0.0990637472942168 -1.764 0.7054509910138511 0.7054495383613464 -2.966459870419602e-07 -0.09906403037929797 -1.7641000000000002 0.7054514897252852 0.7054500425547412 -2.985019541754119e-07 -0.09906431337918793 -1.7642 0.7054519882662913 0.7054505466160379 -3.0029868518244296e-07 -0.09906459629391215 -1.7643000000000002 0.7054524866375547 0.705451050544642 -3.020357849208011e-07 -0.09906487912349594 -1.7644000000000002 0.7054529848397642 0.7054515543399551 -3.0371287204622455e-07 -0.09906516186796471 -1.7645 0.7054534828736129 0.705452058001375 -3.0532957909917835e-07 -0.0990654445273439 -1.7646000000000002 0.7054539807397977 0.7054525615282952 -3.0688555260893757e-07 -0.09906572710165878 -1.7647 0.7054544784390187 0.7054530649201058 -3.083804531664458e-07 -0.09906600959093473 -1.7648000000000001 0.7054549759719797 0.7054535681761935 -3.098139555110513e-07 -0.09906629199519706 -1.7649000000000001 0.705455473339388 0.7054540712959418 -3.1118574853050696e-07 -0.09906657431447122 -1.765 0.7054559705419537 0.7054545742787307 -3.124955353997483e-07 -0.09906685654878244 -1.7651000000000001 0.7054564675803903 0.7054550771239374 -3.1374303362252665e-07 -0.09906713869815612 -1.7652 0.7054569644554134 0.7054555798309361 -3.149279751077372e-07 -0.09906742076261749 -1.7653 0.7054574611677422 0.7054560823990986 -3.1605010616941875e-07 -0.09906770274219197 -1.7654 0.7054579577180979 0.7054565848277938 -3.1710918768634855e-07 -0.0990679846369048 -1.7655 0.7054584541072042 0.7054570871163883 -3.181049950326531e-07 -0.0990682664467813 -1.7656 0.705458950335787 0.7054575892642465 -3.190373182235251e-07 -0.09906854817184677 -1.7657 0.705459446404574 0.7054580912707309 -3.199059618944067e-07 -0.09906882981212645 -1.7658000000000003 0.7054599423142954 0.7054585931352011 -3.2071074537037836e-07 -0.09906911136764564 -1.7659 0.7054604380656826 0.7054590948570163 -3.2145150268697575e-07 -0.09906939283842961 -1.766 0.7054609336594689 0.7054595964355337 -3.221280826318229e-07 -0.09906967422450366 -1.7661000000000002 0.7054614290963885 0.7054600978701084 -3.2274034883483793e-07 -0.09906995552589297 -1.7662 0.7054619243771778 0.7054605991600948 -3.2328817967108847e-07 -0.09907023674262283 -1.7663000000000002 0.7054624195025736 0.705461100304846 -3.237714683995696e-07 -0.09907051787471849 -1.7664000000000002 0.7054629144733138 0.7054616013037142 -3.241901230799371e-07 -0.09907079892220517 -1.7665 0.7054634092901368 0.7054621021560505 -3.2454406669046865e-07 -0.09907107988510809 -1.7666000000000002 0.7054639039537824 0.7054626028612054 -3.248332370794915e-07 -0.09907136076345241 -1.7667 0.7054643984649902 0.7054631034185295 -3.2505758697926046e-07 -0.09907164155726339 -1.7668000000000001 0.7054648928245004 0.7054636038273724 -3.2521708405452987e-07 -0.09907192226656628 -1.7669000000000001 0.7054653870330534 0.7054641040870837 -3.2531171088867605e-07 -0.09907220289138621 -1.767 0.7054658810913893 0.705464604197013 -3.2534146490736937e-07 -0.09907248343174838 -1.7671000000000001 0.7054663750002481 0.7054651041565101 -3.2530635850347434e-07 -0.09907276388767794 -1.7672 0.7054668687603699 0.7054656039649251 -3.252064189190884e-07 -0.09907304425920012 -1.7673 0.7054673623724936 0.7054661036216086 -3.250416882871754e-07 -0.09907332454634005 -1.7674 0.7054678558373582 0.7054666031259114 -3.2481222363156537e-07 -0.09907360474912291 -1.7675 0.7054683491557012 0.7054671024771857 -3.245180968114436e-07 -0.09907388486757379 -1.7676 0.7054688423282598 0.7054676016747845 -3.2415939452828946e-07 -0.09907416490171793 -1.7677 0.7054693353557695 0.7054681007180614 -3.237362182911818e-07 -0.0990744448515804 -1.7678000000000003 0.705469828238965 0.7054685996063719 -3.2324868438210475e-07 -0.09907472471718634 -1.7679 0.7054703209785791 0.7054690983390723 -3.2269692381431403e-07 -0.09907500449856087 -1.768 0.7054708135753436 0.7054695969155211 -3.22081082346215e-07 -0.09907528419572913 -1.7681000000000002 0.7054713060299876 0.705470095335078 -3.214013203980959e-07 -0.09907556380871615 -1.7682 0.7054717983432395 0.7054705935971048 -3.206578130382498e-07 -0.09907584333754711 -1.7683000000000002 0.7054722905158244 0.7054710917009657 -3.198507498997083e-07 -0.09907612278224709 -1.7684000000000002 0.7054727825484663 0.7054715896460264 -3.1898033518718005e-07 -0.09907640214284115 -1.7685 0.705473274441886 0.7054720874316553 -3.1804678755908977e-07 -0.09907668141935438 -1.7686000000000002 0.705473766196802 0.7054725850572237 -3.170503401692115e-07 -0.09907696061181182 -1.7687 0.7054742578139306 0.7054730825221045 -3.1599124051401306e-07 -0.0990772397202386 -1.7688000000000001 0.7054747492939845 0.7054735798256748 -3.148697503979614e-07 -0.09907751874465973 -1.7689000000000001 0.7054752406376739 0.7054740769673133 -3.1368614589188937e-07 -0.09907779768510026 -1.769 0.7054757318457052 0.7054745739464028 -3.124407172636068e-07 -0.0990780765415852 -1.7691000000000001 0.7054762229187825 0.7054750707623288 -3.1113376887381694e-07 -0.09907835531413961 -1.7692 0.7054767138576059 0.705475567414481 -3.097656191483611e-07 -0.09907863400278855 -1.7693 0.7054772046628719 0.7054760639022517 -3.0833660046719613e-07 -0.09907891260755697 -1.7694 0.7054776953352733 0.7054765602250374 -3.0684705908806675e-07 -0.09907919112846994 -1.7695 0.7054781858754988 0.7054770563822383 -3.052973551048721e-07 -0.09907946956555244 -1.7696 0.7054786762842338 0.705477552373259 -3.0368786225337674e-07 -0.0990797479188295 -1.7697 0.7054791665621585 0.7054780481975079 -3.020189679597829e-07 -0.09908002618832602 -1.7698000000000003 0.7054796567099494 0.7054785438543976 -3.0029107314644143e-07 -0.09908030437406704 -1.7699 0.7054801467282785 0.7054790393433454 -2.985045921971574e-07 -0.09908058247607753 -1.77 0.7054806366178128 0.7054795346637733 -2.9665995279412605e-07 -0.09908086049438247 -1.7701000000000002 0.7054811263792151 0.7054800298151079 -2.947575958936466e-07 -0.09908113842900682 -1.7702 0.7054816160131429 0.7054805247967806 -2.927979755491805e-07 -0.09908141627997552 -1.7703000000000002 0.7054821055202486 0.7054810196082275 -2.907815588454321e-07 -0.09908169404731348 -1.7704000000000002 0.7054825949011799 0.7054815142488906 -2.8870882576650936e-07 -0.09908197173104571 -1.7705 0.7054830841565787 0.7054820087182168 -2.865802691091879e-07 -0.09908224933119708 -1.7706000000000002 0.7054835732870816 0.7054825030156577 -2.843963943510719e-07 -0.09908252684779251 -1.7707 0.7054840622933194 0.705482997140672 -2.8215771949793855e-07 -0.09908280428085692 -1.7708000000000002 0.7054845511759182 0.705483491092723 -2.798647750178185e-07 -0.09908308163041529 -1.7709000000000001 0.705485039935497 0.7054839848712802 -2.775181036744623e-07 -0.09908335889649252 -1.771 0.7054855285726692 0.7054844784758189 -2.751182604336655e-07 -0.09908363607911341 -1.7711000000000001 0.7054860170880424 0.7054849719058203 -2.726658122863268e-07 -0.0990839131783029 -1.7712 0.7054865054822175 0.7054854651607722 -2.701613381443646e-07 -0.09908419019408589 -1.7713 0.7054869937557896 0.7054859582401685 -2.676054286984697e-07 -0.09908446712648722 -1.7714 0.7054874819093467 0.7054864511435095 -2.6499868631055246e-07 -0.09908474397553173 -1.7715 0.7054879699434707 0.7054869438703026 -2.6234172481251483e-07 -0.09908502074124433 -1.7716 0.7054884578587364 0.705487436420061 -2.596351694160448e-07 -0.09908529742364981 -1.7717 0.7054889456557121 0.7054879287923059 -2.568796564940412e-07 -0.0990855740227731 -1.7718000000000003 0.7054894333349585 0.7054884209865642 -2.5407583351122476e-07 -0.09908585053863893 -1.7719 0.7054899208970302 0.7054889130023706 -2.5122435885760463e-07 -0.09908612697127218 -1.772 0.7054904083424738 0.705489404839267 -2.483259016437811e-07 -0.09908640332069772 -1.7721000000000002 0.7054908956718288 0.705489896496802 -2.453811415829843e-07 -0.09908667958694027 -1.7722 0.7054913828856275 0.7054903879745327 -2.4239076882801025e-07 -0.09908695577002476 -1.7723000000000002 0.7054918699843943 0.7054908792720225 -2.3935548378734017e-07 -0.09908723186997585 -1.7724000000000002 0.7054923569686462 0.7054913703888428 -2.3627599702105706e-07 -0.09908750788681839 -1.7725 0.7054928438388923 0.7054918613245733 -2.331530290118622e-07 -0.0990877838205772 -1.7726000000000002 0.7054933305956341 0.7054923520788008 -2.2998730999507222e-07 -0.09908805967127703 -1.7727 0.7054938172393648 0.7054928426511204 -2.2677957985106634e-07 -0.09908833543894265 -1.7728000000000002 0.7054943037705699 0.705493333041135 -2.2353058786589441e-07 -0.09908861112359879 -1.7729000000000001 0.7054947901897264 0.7054938232484562 -2.2024109259943803e-07 -0.09908888672527029 -1.773 0.7054952764973035 0.7054943132727033 -2.1691186168418253e-07 -0.09908916224398188 -1.7731000000000001 0.7054957626937612 0.7054948031135037 -2.135436716448058e-07 -0.09908943767975822 -1.7732 0.705496248779552 0.7054952927704938 -2.1013730774552264e-07 -0.09908971303262415 -1.7733 0.7054967347551191 0.7054957822433183 -2.0669356378538728e-07 -0.09908998830260425 -1.7734 0.7054972206208978 0.7054962715316302 -2.0321324190053502e-07 -0.09909026348972338 -1.7735 0.7054977063773142 0.7054967606350918 -1.9969715241152652e-07 -0.0990905385940062 -1.7736 0.7054981920247858 0.7054972495533736 -1.961461135943643e-07 -0.09909081361547743 -1.7737 0.7054986775637213 0.7054977382861553 -1.9256095154518427e-07 -0.09909108855416177 -1.7738000000000003 0.70549916299452 0.7054982268331251 -1.889424999269862e-07 -0.09909136341008387 -1.7739 0.7054996483175726 0.7054987151939808 -1.8529159981697796e-07 -0.09909163818326844 -1.774 0.7055001335332607 0.7054992033684289 -1.816090995088171e-07 -0.09909191287374018 -1.7741000000000002 0.7055006186419562 0.7054996913561853 -1.7789585426628007e-07 -0.09909218748152374 -1.7742 0.7055011036440222 0.7055001791569749 -1.741527262053011e-07 -0.09909246200664378 -1.7743000000000002 0.7055015885398126 0.7055006667705321 -1.7038058404937606e-07 -0.09909273644912492 -1.7744000000000002 0.7055020733296714 0.7055011541966004 -1.6658030290925274e-07 -0.09909301080899187 -1.7745 0.7055025580139336 0.7055016414349333 -1.6275276409731532e-07 -0.09909328508626927 -1.7746000000000002 0.7055030425929242 0.7055021284852931 -1.5889885496278566e-07 -0.09909355928098171 -1.7747 0.705503527066959 0.705502615347452 -1.5501946861763705e-07 -0.09909383339315378 -1.7748000000000002 0.7055040114363438 0.7055031020211919 -1.5111550378220373e-07 -0.09909410742281016 -1.7749000000000001 0.7055044957013751 0.7055035885063046 -1.471878645579322e-07 -0.09909438136997548 -1.775 0.7055049798623395 0.7055040748025911 -1.4323746020186712e-07 -0.09909465523467431 -1.7751000000000001 0.7055054639195135 0.7055045609098627 -1.3926520495144423e-07 -0.09909492901693126 -1.7752000000000001 0.705505947873164 0.70550504682794 -1.3527201778336384e-07 -0.09909520271677091 -1.7753 0.705506431723548 0.7055055325566539 -1.3125882222103646e-07 -0.09909547633421784 -1.7754 0.7055069154709124 0.7055060180958453 -1.2722654610559936e-07 -0.09909574986929665 -1.7755 0.7055073991154944 0.7055065034453649 -1.2317612137734135e-07 -0.09909602332203193 -1.7756 0.7055078826575203 0.7055069886050733 -1.191084839022305e-07 -0.09909629669244815 -1.7757 0.705508366097207 0.7055074735748412 -1.1502457319435833e-07 -0.0990965699805699 -1.7758000000000003 0.7055088494347614 0.7055079583545498 -1.1092533223899803e-07 -0.09909684318642174 -1.7759 0.7055093326703801 0.7055084429440901 -1.0681170727229461e-07 -0.09909711631002822 -1.776 0.7055098158042492 0.7055089273433633 -1.0268464754187301e-07 -0.09909738935141389 -1.7761000000000002 0.7055102988365449 0.7055094115522806 -9.854510511862064e-08 -0.09909766231060324 -1.7762 0.705510781767433 0.7055098955707639 -9.439403464775453e-08 -0.09909793518762076 -1.7763000000000002 0.7055112645970693 0.705510379398745 -9.023239314846082e-08 -0.09909820798249103 -1.7764000000000002 0.7055117473255986 0.705510863036166 -8.606113978317648e-08 -0.0990984806952385 -1.7765 0.7055122299531564 0.7055113464829792 -8.188123563381e-08 -0.09909875332588772 -1.7766000000000002 0.705512712479867 0.7055118297391477 -7.769364350138086e-08 -0.09909902587446313 -1.7767 0.7055131949058445 0.7055123128046443 -7.34993276562193e-08 -0.09909929834098921 -1.7768000000000002 0.7055136772311932 0.7055127956794527 -6.929925363630476e-08 -0.09909957072549047 -1.7769000000000001 0.7055141594560064 0.7055132783635664 -6.509438801394554e-08 -0.09909984302799135 -1.777 0.7055146415803675 0.7055137608569896 -6.08856981785047e-08 -0.09910011524851636 -1.7771000000000001 0.7055151236043491 0.705514243159737 -5.66741521119702e-08 -0.09910038738708993 -1.7772000000000001 0.7055156055280136 0.7055147252718332 -5.246071816951241e-08 -0.0991006594437365 -1.7773 0.7055160873514127 0.7055152071933135 -4.8246364853319484e-08 -0.09910093141848048 -1.7774 0.7055165690745882 0.7055156889242236 -4.4032060590823863e-08 -0.09910120331134631 -1.7775 0.7055170506975712 0.7055161704646191 -3.981877351292868e-08 -0.09910147512235841 -1.7776 0.7055175322203826 0.7055166518145668 -3.5607471232938954e-08 -0.09910174685154124 -1.7777 0.7055180136430328 0.705517132974143 -3.1399120620613855e-08 -0.0991020184989192 -1.7778000000000003 0.705518494965522 0.7055176139434349 -2.7194687583862592e-08 -0.09910229006451668 -1.7779 0.7055189761878397 0.7055180947225399 -2.2995136847187708e-08 -0.09910256154835806 -1.778 0.7055194573099652 0.7055185753115653 -1.880143172703838e-08 -0.09910283295046773 -1.7781000000000002 0.705519938331868 0.7055190557106295 -1.4614533917246819e-08 -0.09910310427087014 -1.7782 0.7055204192535063 0.7055195359198604 -1.0435403256358472e-08 -0.09910337550958959 -1.7783000000000002 0.705520900074829 0.7055200159393966 -6.264997522500981e-09 -0.0991036466666505 -1.7784 0.7055213807957741 0.7055204957693866 -2.1042722061354047e-09 -0.0991039177420772 -1.7785 0.7055218614162695 0.7055209754099896 2.045819709819985e-09 -0.09910418873589401 -1.7786000000000002 0.7055223419362334 0.7055214548613743 6.184327966396452e-09 -0.09910445964812535 -1.7787 0.7055228223555732 0.7055219341237202 1.0310305241512108e-08 -0.0991047304787955 -1.7788000000000002 0.7055233026741865 0.7055224131972163 1.442280737635332e-08 -0.09910500122792884 -1.7789000000000001 0.7055237828919604 0.7055228920820621 1.8520893584408893e-08 -0.09910527189554963 -1.779 0.7055242630087726 0.7055233707784669 2.2603626668310506e-08 -0.09910554248168221 -1.7791000000000001 0.7055247430244904 0.7055238492866504 2.6670073233203695e-08 -0.09910581298635093 -1.7792000000000001 0.7055252229389712 0.7055243276068417 3.071930389925148e-08 -0.0991060834095801 -1.7793 0.7055257027520625 0.70552480573928 3.475039351934217e-08 -0.09910635375139398 -1.7794 0.7055261824636019 0.7055252836842143 3.876242138552144e-08 -0.09910662401181687 -1.7795 0.7055266620734169 0.7055257614419036 4.2754471440628605e-08 -0.09910689419087304 -1.7796 0.7055271415813257 0.7055262390126165 4.6725632488198166e-08 -0.09910716428858675 -1.7797 0.7055276209871365 0.7055267163966312 5.067499839021827e-08 -0.09910743430498231 -1.7798000000000003 0.7055281002906482 0.705527193594236 5.4601668296114236e-08 -0.09910770424008401 -1.7799 0.7055285794916493 0.7055276706057277 5.850474682836393e-08 -0.09910797409391599 -1.78 0.7055290585899199 0.7055281474314139 6.238334428892989e-08 -0.09910824386650258 -1.7801000000000002 0.7055295375852293 0.705528624071611 6.623657687609974e-08 -0.099108513557868 -1.7802 0.7055300164773385 0.7055291005266449 7.00635668753058e-08 -0.0991087831680365 -1.7803000000000002 0.7055304952659988 0.7055295767968506 7.386344284820989e-08 -0.09910905269703228 -1.7804 0.7055309739509519 0.705530052882573 7.763533984954385e-08 -0.09910932214487962 -1.7805 0.7055314525319307 0.7055305287841651 8.137839961966375e-08 -0.09910959151160265 -1.7806000000000002 0.705531931008659 0.7055310045019898 8.509177077536956e-08 -0.09910986079722557 -1.7807 0.705532409380851 0.7055314800364189 8.877460901460243e-08 -0.09911013000177263 -1.7808000000000002 0.7055328876482123 0.7055319553878332 9.242607726736574e-08 -0.09911039912526798 -1.7809000000000001 0.7055333658104399 0.7055324305566222 9.604534594379044e-08 -0.09911066816773581 -1.781 0.7055338438672216 0.7055329055431845 9.96315931006686e-08 -0.09911093712920038 -1.7811000000000001 0.7055343218182368 0.7055333803479267 1.0318400460104793e-07 -0.09911120600968576 -1.7812000000000001 0.7055347996631556 0.7055338549712646 1.0670177433974581e-07 -0.09911147480921612 -1.7813 0.7055352774016401 0.7055343294136227 1.1018410440641335e-07 -0.09911174352781568 -1.7814 0.7055357550333439 0.7055348036754334 1.1363020526247714e-07 -0.0991120121655085 -1.7815 0.7055362325579122 0.7055352777571378 1.170392959146116e-07 -0.0991122807223188 -1.7816 0.7055367099749819 0.7055357516591851 1.2041060412290583e-07 -0.09911254919827073 -1.7817 0.7055371872841812 0.7055362253820326 1.2374336654658036e-07 -0.09911281759338829 -1.7818000000000003 0.7055376644851312 0.705536698926146 1.2703682892092893e-07 -0.09911308590769574 -1.7819 0.7055381415774442 0.7055371722919983 1.3029024623772978e-07 -0.09911335414121705 -1.782 0.7055386185607251 0.705537645480071 1.3350288291871792e-07 -0.09911362229397641 -1.7821000000000002 0.7055390954345707 0.7055381184908531 1.366740129543631e-07 -0.0991138903659979 -1.7822 0.7055395721985706 0.7055385913248414 1.3980292006693373e-07 -0.09911415835730567 -1.7823000000000002 0.7055400488523061 0.7055390639825398 1.4288889796029713e-07 -0.09911442626792372 -1.7824 0.7055405253953518 0.7055395364644604 1.4593125033379728e-07 -0.0991146940978762 -1.7825 0.7055410018272743 0.7055400087711219 1.4892929115981057e-07 -0.0991149618471871 -1.7826000000000002 0.7055414781476335 0.7055404809030502 1.5188234477048201e-07 -0.09911522951588052 -1.7827 0.7055419543559815 0.705540952860779 1.54789746034667e-07 -0.09911549710398049 -1.7828000000000002 0.705542430451864 0.7055414246448487 1.5765084050711753e-07 -0.09911576461151111 -1.7829000000000002 0.70554290643482 0.7055418962558062 1.6046498459848513e-07 -0.09911603203849642 -1.783 0.7055433823043806 0.7055423676942054 1.6323154566552645e-07 -0.09911629938496039 -1.7831000000000001 0.7055438580600718 0.7055428389606069 1.659499021984534e-07 -0.09911656665092713 -1.7832000000000001 0.7055443337014117 0.7055433100555779 1.6861944394583328e-07 -0.09911683383642061 -1.7833 0.7055448092279124 0.7055437809796915 1.7123957203601936e-07 -0.09911710094146482 -1.7834 0.7055452846390803 0.7055442517335277 1.7380969914715383e-07 -0.09911736796608384 -1.7835 0.705545759934415 0.7055447223176725 1.763292495904345e-07 -0.09911763491030164 -1.7836 0.7055462351134103 0.7055451927327174 1.7879765950440385e-07 -0.0991179017741422 -1.7837 0.7055467101755537 0.7055456629792602 1.8121437691046016e-07 -0.0991181685576295 -1.7838000000000003 0.7055471851203275 0.7055461330579044 1.8357886189326877e-07 -0.09911843526078752 -1.7839 0.7055476599472081 0.7055466029692593 1.858905866909677e-07 -0.09911870188364026 -1.784 0.7055481346556662 0.7055470727139395 1.881490358131288e-07 -0.09911896842621169 -1.7841000000000002 0.7055486092451675 0.7055475422925649 1.903537061483107e-07 -0.0991192348885257 -1.7842 0.705549083715172 0.7055480117057606 1.9250410708201993e-07 -0.09911950127060631 -1.7843000000000002 0.7055495580651349 0.7055484809541572 1.945997606667138e-07 -0.09911976757247742 -1.7844 0.7055500322945063 0.7055489500383899 1.966402016356783e-07 -0.09912003379416298 -1.7845 0.7055505064027314 0.7055494189590985 1.9862497755568365e-07 -0.09912029993568691 -1.7846000000000002 0.705550980389251 0.7055498877169277 2.0055364891025107e-07 -0.09912056599707314 -1.7847 0.7055514542535009 0.7055503563125272 2.0242578919679732e-07 -0.09912083197834556 -1.7848000000000002 0.7055519279949127 0.7055508247465505 2.0424098502030974e-07 -0.09912109787952814 -1.7849000000000002 0.7055524016129139 0.7055512930196557 2.0599883620436854e-07 -0.09912136370064473 -1.785 0.7055528751069274 0.7055517611325048 2.07698955877883e-07 -0.09912162944171929 -1.7851000000000001 0.7055533484763726 0.7055522290857639 2.0934097053407208e-07 -0.09912189510277561 -1.7852000000000001 0.7055538217206647 0.7055526968801027 2.1092452012066998e-07 -0.09912216068383765 -1.7853 0.7055542948392153 0.7055531645161948 2.1244925812666238e-07 -0.09912242618492922 -1.7854 0.7055547678314323 0.7055536319947172 2.1391485166902258e-07 -0.0991226916060742 -1.7855 0.7055552406967207 0.7055540993163505 2.1532098153434487e-07 -0.09912295694729648 -1.7856 0.7055557134344814 0.7055545664817784 2.1666734226211126e-07 -0.09912322220861987 -1.7857 0.7055561860441132 0.7055550334916878 2.1795364222448876e-07 -0.09912348739006828 -1.7858000000000003 0.7055566585250113 0.7055555003467684 2.191796037095961e-07 -0.09912375249166555 -1.7859 0.7055571308765677 0.7055559670477127 2.2034496287987038e-07 -0.09912401751343544 -1.786 0.7055576030981724 0.7055564335952159 2.2144946995594772e-07 -0.09912428245540178 -1.7861000000000002 0.7055580751892128 0.7055568999899756 2.2249288920278554e-07 -0.09912454731758844 -1.7862 0.7055585471490737 0.7055573662326919 2.2347499897129586e-07 -0.0991248121000192 -1.7863000000000002 0.7055590189771378 0.7055578323240672 2.2439559178855095e-07 -0.09912507680271784 -1.7864 0.7055594906727858 0.7055582982648055 2.2525447433696666e-07 -0.09912534142570821 -1.7865 0.7055599622353964 0.7055587640556131 2.2605146758614136e-07 -0.09912560596901408 -1.7866000000000002 0.7055604336643468 0.7055592296971978 2.2678640674428374e-07 -0.09912587043265926 -1.7867 0.7055609049590118 0.7055596951902687 2.2745914134841838e-07 -0.09912613481666743 -1.7868000000000002 0.7055613761187658 0.7055601605355374 2.280695352296913e-07 -0.09912639912106247 -1.7869000000000002 0.7055618471429811 0.7055606257337154 2.286174666313312e-07 -0.09912666334586803 -1.787 0.7055623180310293 0.7055610907855163 2.2910282818783267e-07 -0.09912692749110798 -1.7871000000000001 0.7055627887822808 0.7055615556916544 2.2952552685556737e-07 -0.09912719155680597 -1.7872000000000001 0.7055632593961055 0.7055620204528444 2.29885484107073e-07 -0.09912745554298584 -1.7873 0.705563729871872 0.7055624850698023 2.3018263583390874e-07 -0.09912771944967122 -1.7874 0.705564200208949 0.7055629495432443 2.3041693236053318e-07 -0.09912798327688593 -1.7875 0.7055646704067045 0.7055634138738867 2.3058833846512083e-07 -0.0991282470246536 -1.7876 0.7055651404645065 0.7055638780624464 2.3069683340731784e-07 -0.09912851069299802 -1.7877 0.7055656103817224 0.7055643421096398 2.3074241087273073e-07 -0.09912877428194283 -1.7878000000000003 0.7055660801577205 0.705564806016184 2.3072507903537653e-07 -0.09912903779151178 -1.7879 0.7055665497918687 0.7055652697827951 2.3064486052298827e-07 -0.09912930122172853 -1.788 0.7055670192835359 0.7055657334101892 2.305017923823205e-07 -0.09912956457261682 -1.7881000000000002 0.705567488632091 0.7055661968990816 2.3029592613466043e-07 -0.09912982784420027 -1.7882 0.7055679578369038 0.7055666602501866 2.3002732763705014e-07 -0.09913009103650257 -1.7883000000000002 0.705568426897345 0.705567123464218 2.2969607722106433e-07 -0.09913035414954735 -1.7884 0.7055688958127866 0.7055675865418887 2.2930226952627697e-07 -0.0991306171833583 -1.7885 0.7055693645826011 0.7055680494839099 2.2884601357658907e-07 -0.09913088013795912 -1.7886000000000002 0.705569833206163 0.7055685122909919 2.2832743271777867e-07 -0.09913114301337335 -1.7887 0.705570301682848 0.7055689749638433 2.277466645134174e-07 -0.09913140580962472 -1.7888000000000002 0.7055707700120333 0.7055694375031706 2.2710386086283174e-07 -0.09913166852673677 -1.7889000000000002 0.7055712381930984 0.7055698999096793 2.2639918782763058e-07 -0.09913193116473323 -1.789 0.7055717062254241 0.7055703621840725 2.2563282562476639e-07 -0.09913219372363762 -1.7891000000000001 0.7055721741083937 0.7055708243270512 2.24804968640413e-07 -0.09913245620347362 -1.7892000000000001 0.7055726418413926 0.705571286339314 2.2391582527037102e-07 -0.09913271860426477 -1.7893000000000001 0.7055731094238086 0.7055717482215575 2.229656179825179e-07 -0.09913298092603473 -1.7894 0.7055735768550317 0.7055722099744752 2.2195458319884676e-07 -0.09913324316880699 -1.7895 0.7055740441344557 0.7055726715987582 2.2088297123301626e-07 -0.09913350533260519 -1.7896 0.7055745112614761 0.705573133095095 2.1975104622790065e-07 -0.09913376741745294 -1.7897 0.7055749782354916 0.7055735944641703 2.1855908614171193e-07 -0.09913402942337375 -1.7898000000000003 0.7055754450559046 0.7055740557066665 2.173073826230998e-07 -0.09913429135039124 -1.7899 0.7055759117221202 0.705574516823262 2.159962409764571e-07 -0.09913455319852887 -1.79 0.7055763782335472 0.7055749778146323 2.146259800717143e-07 -0.09913481496781029 -1.7901000000000002 0.705576844589598 0.705575438681449 2.1319693225760328e-07 -0.09913507665825899 -1.7902 0.7055773107896884 0.7055758994243799 2.1170944328532948e-07 -0.09913533826989851 -1.7903000000000002 0.7055777768332383 0.7055763600440892 2.101638722634691e-07 -0.09913559980275237 -1.7904 0.7055782427196715 0.7055768205412369 2.0856059150531348e-07 -0.09913586125684404 -1.7905 0.7055787084484161 0.7055772809164786 2.068999865011134e-07 -0.0991361226321971 -1.7906000000000002 0.7055791740189044 0.7055777411704662 2.051824557654236e-07 -0.09913638392883505 -1.7907 0.7055796394305732 0.7055782013038467 2.0340841079546923e-07 -0.09913664514678139 -1.7908000000000002 0.7055801046828636 0.7055786613172629 2.0157827597400146e-07 -0.09913690628605962 -1.7909000000000002 0.7055805697752217 0.705579121211352 1.9969248842358067e-07 -0.0991371673466932 -1.791 0.7055810347070981 0.7055795809867474 1.9775149791290136e-07 -0.0991374283287056 -1.7911000000000001 0.7055814994779486 0.7055800406440768 1.9575576678046436e-07 -0.09913768923212028 -1.7912000000000001 0.7055819640872343 0.7055805001839632 1.937057698027378e-07 -0.09913795005696074 -1.7913000000000001 0.7055824285344209 0.705580959607024 1.9160199408660428e-07 -0.0991382108032504 -1.7914 0.7055828928189799 0.7055814189138716 1.894449389444608e-07 -0.09913847147101273 -1.7915 0.7055833569403883 0.7055818781051129 1.872351157970742e-07 -0.09913873206027118 -1.7916 0.7055838208981287 0.7055823371813486 1.8497304801398662e-07 -0.0991389925710492 -1.7917 0.7055842846916893 0.7055827961431742 1.8265927082677935e-07 -0.09913925300337022 -1.7918000000000003 0.7055847483205642 0.7055832549911788 1.8029433120764216e-07 -0.0991395133572576 -1.7919 0.7055852117842536 0.705583713725946 1.7787878770283982e-07 -0.0991397736327348 -1.792 0.7055856750822636 0.705584172348053 1.7541321033209822e-07 -0.09914003382982522 -1.7921 0.7055861382141071 0.7055846308580708 1.7289818043941807e-07 -0.09914029394855228 -1.7922 0.7055866011793025 0.7055850892565638 1.703342905577665e-07 -0.09914055398893935 -1.7923000000000002 0.7055870639773754 0.7055855475440904 1.6772214427723808e-07 -0.09914081395100986 -1.7924 0.7055875266078575 0.705586005721202 1.6506235608892972e-07 -0.09914107383478715 -1.7925 0.7055879890702875 0.7055864637884431 1.6235555126004053e-07 -0.0991413336402946 -1.7926000000000002 0.7055884513642112 0.705586921746352 1.5960236566733843e-07 -0.09914159336755565 -1.7927 0.7055889134891806 0.7055873795954593 1.5680344567226e-07 -0.09914185301659356 -1.7928000000000002 0.7055893754447551 0.7055878373362892 1.5395944792662153e-07 -0.09914211258743173 -1.7929000000000002 0.7055898372305014 0.7055882949693579 1.5107103928588272e-07 -0.09914237208009347 -1.793 0.7055902988459929 0.7055887524951753 1.4813889656628554e-07 -0.09914263149460216 -1.7931000000000001 0.7055907602908114 0.7055892099142433 1.4516370647546517e-07 -0.09914289083098114 -1.7932000000000001 0.7055912215645452 0.7055896672270561 1.4214616537999714e-07 -0.0991431500892537 -1.7933000000000001 0.7055916826667907 0.7055901244341012 1.390869791978444e-07 -0.09914340926944316 -1.7934 0.7055921435971517 0.7055905815358573 1.3598686318672115e-07 -0.09914366837157287 -1.7935 0.7055926043552397 0.7055910385327964 1.328465418018454e-07 -0.09914392739566612 -1.7936 0.7055930649406745 0.7055914954253815 1.2966674852940563e-07 -0.09914418634174615 -1.7937 0.7055935253530835 0.7055919522140687 1.2644822570268e-07 -0.0991444452098364 -1.7938000000000003 0.7055939855921023 0.7055924088993051 1.2319172432856407e-07 -0.09914470399995999 -1.7939 0.7055944456573744 0.70559286548153 1.1989800394185401e-07 -0.09914496271214028 -1.794 0.7055949055485522 0.705593321961175 1.165678323901409e-07 -0.09914522134640058 -1.7941 0.7055953652652953 0.7055937783386625 1.1320198566033834e-07 -0.09914547990276411 -1.7942 0.7055958248072729 0.7055942346144066 1.0980124774337408e-07 -0.09914573838125412 -1.7943000000000002 0.7055962841741615 0.7055946907888138 1.0636641037398142e-07 -0.09914599678189387 -1.7944 0.7055967433656471 0.7055951468622803 1.0289827291273812e-07 -0.09914625510470658 -1.7945 0.7055972023814242 0.7055956028351953 9.939764212402169e-08 -0.09914651334971548 -1.7946000000000002 0.7055976612211958 0.7055960587079385 9.586533202682324e-08 -0.09914677151694391 -1.7947 0.7055981198846737 0.7055965144808808 9.230216364147781e-08 -0.09914702960641497 -1.7948000000000002 0.7055985783715787 0.705596970154384 8.870896485088653e-08 -0.09914728761815193 -1.7949000000000002 0.7055990366816403 0.7055974257288018 8.508657019581922e-08 -0.09914754555217803 -1.795 0.7055994948145974 0.7055978812044779 8.143582068062538e-08 -0.09914780340851642 -1.7951000000000001 0.7055999527701977 0.7055983365817471 7.775756358588404e-08 -0.09914806118719033 -1.7952000000000001 0.7056004105481983 0.7055987918609354 7.405265224462443e-08 -0.09914831888822295 -1.7953000000000001 0.7056008681483651 0.7055992470423592 7.032194587926199e-08 -0.09914857651163744 -1.7954 0.7056013255704734 0.705599702126326 6.656630937088015e-08 -0.09914883405745697 -1.7955 0.7056017828143082 0.7056001571131333 6.278661309443156e-08 -0.09914909152570472 -1.7956 0.7056022398796634 0.7056006120030698 5.8983732670672695e-08 -0.09914934891640388 -1.7957 0.7056026967663427 0.7056010667964144 5.515854881003868e-08 -0.09914960622957754 -1.7958000000000003 0.7056031534741589 0.705601521493437 5.1311947073251485e-08 -0.09914986346524891 -1.7959 0.705603610002935 0.7056019760943973 4.7444817692643415e-08 -0.09915012062344114 -1.796 0.7056040663525028 0.7056024305995456 4.3558055348377756e-08 -0.09915037770417734 -1.7961 0.7056045225227043 0.7056028850091227 3.965255896895559e-08 -0.09915063470748064 -1.7962 0.7056049785133905 0.7056033393233593 3.5729231523048965e-08 -0.0991508916333741 -1.7963000000000002 0.7056054343244232 0.7056037935424773 3.178897980959938e-08 -0.09915114848188096 -1.7964 0.7056058899556732 0.7056042476666877 2.7832714249650947e-08 -0.0991514052530243 -1.7965 0.7056063454070209 0.705604701696192 2.3861348671244675e-08 -0.09915166194682715 -1.7966000000000002 0.7056068006783571 0.7056051556311825 1.9875800108190567e-08 -0.09915191856331264 -1.7967 0.7056072557695823 0.705605609471841 1.587698857889036e-08 -0.09915217510250396 -1.7968000000000002 0.7056077106806065 0.7056060632183393 1.1865836875568636e-08 -0.09915243156442399 -1.7969000000000002 0.70560816541135 0.7056065168708396 7.843270362177523e-09 -0.09915268794909594 -1.797 0.705608619961743 0.705606970429494 3.810216747147932e-09 -0.09915294425654286 -1.7971000000000001 0.7056090743317256 0.7056074238944445 -2.323941265119922e-10 -0.0991532004867878 -1.7972000000000001 0.7056095285212478 0.7056078772658236 -4.283630493720492e-09 -0.09915345663985381 -1.7973000000000001 0.7056099825302695 0.705608330543753 -8.342558877223738e-09 -0.09915371271576391 -1.7974 0.7056104363587611 0.7056087837283451 -1.2408244313977246e-08 -0.09915396871454117 -1.7975 0.7056108900067026 0.705609236819702 -1.647975056374637e-08 -0.09915422463620865 -1.7976 0.705611343474084 0.7056096898179153 -2.0556140322477295e-08 -0.09915448048078933 -1.7977 0.7056117967609057 0.7056101427230672 -2.4636475442173233e-08 -0.09915473624830627 -1.7978000000000003 0.7056122498671777 0.7056105955352292 -2.8719817144265414e-08 -0.09915499193878244 -1.7979 0.7056127027929209 0.7056110482544634 -3.28052262379714e-08 -0.09915524755224091 -1.798 0.7056131555381651 0.7056115008808213 -3.6891763333882915e-08 -0.09915550308870463 -1.7981 0.7056136081029507 0.7056119534143446 -4.097848906015576e-08 -0.09915575854819664 -1.7982 0.7056140604873284 0.7056124058550646 -4.50644642796213e-08 -0.09915601393073985 -1.7983000000000002 0.7056145126913589 0.705612858203003 -4.914875030548847e-08 -0.09915626923635738 -1.7984 0.7056149647151124 0.7056133104581708 -5.323040911438953e-08 -0.09915652446507207 -1.7985 0.7056154165586697 0.7056137626205694 -5.730850356462994e-08 -0.0991567796169069 -1.7986000000000002 0.7056158682221214 0.7056142146901899 -6.138209761091459e-08 -0.09915703469188489 -1.7987 0.7056163197055678 0.7056146666670138 -6.545025652004988e-08 -0.09915728969002892 -1.7988000000000002 0.7056167710091202 0.7056151185510122 -6.951204707889361e-08 -0.099157544611362 -1.7989000000000002 0.7056172221328987 0.7056155703421463 -7.356653781726702e-08 -0.09915779945590704 -1.799 0.705617673077034 0.7056160220403673 -7.761279921698894e-08 -0.099158054223687 -1.7991000000000001 0.7056181238416666 0.7056164736456164 -8.164990392481308e-08 -0.09915830891472474 -1.7992000000000001 0.7056185744269466 0.7056169251578251 -8.56769269627633e-08 -0.09915856352904323 -1.7993000000000001 0.7056190248330347 0.7056173765769148 -8.969294594974447e-08 -0.09915881806666542 -1.7994 0.7056194750601008 0.7056178279027971 -9.369704129930101e-08 -0.09915907252761415 -1.7995 0.7056199251083246 0.7056182791353737 -9.768829643905935e-08 -0.09915932691191233 -1.7996 0.7056203749778958 0.7056187302745365 -1.0166579801716008e-07 -0.09915958121958285 -1.7997 0.7056208246690139 0.7056191813201679 -1.0562863611389417e-07 -0.0991598354506486 -1.7998000000000003 0.7056212741818882 0.7056196322721403 -1.0957590444466564e-07 -0.0991600896051325 -1.7999 0.7056217235167374 0.7056200831303167 -1.1350670056989309e-07 -0.09916034368305746 -1.8 0.7056221726737897 0.7056205338945498 -1.1742012610317654e-07 -0.0991605976844462 -1.8001 0.7056226216532829 0.7056209845646834 -1.2131528692206628e-07 -0.09916085160932167 -1.8002 0.7056230704554647 0.7056214351405514 -1.251912933545457e-07 -0.09916110545770668 -1.8003000000000002 0.7056235190805922 0.7056218856219787 -1.2904726040020853e-07 -0.09916135922962417 -1.8004 0.7056239675289318 0.7056223360087802 -1.328823079158742e-07 -0.09916161292509694 -1.8005 0.7056244158007587 0.7056227863007615 -1.3669556083242829e-07 -0.09916186654414778 -1.8006000000000002 0.7056248638963583 0.7056232364977191 -1.404861493543158e-07 -0.09916212008679953 -1.8007 0.7056253118160245 0.7056236865994399 -1.442532091451565e-07 -0.099162373553075 -1.8008000000000002 0.705625759560061 0.7056241366057017 -1.4799588152376864e-07 -0.09916262694299699 -1.8009000000000002 0.7056262071287807 0.7056245865162737 -1.517133136740706e-07 -0.09916288025658837 -1.801 0.7056266545225047 0.7056250363309154 -1.5540465883243093e-07 -0.09916313349387192 -1.8011000000000001 0.7056271017415638 0.7056254860493774 -1.5906907646981439e-07 -0.09916338665487039 -1.8012000000000001 0.7056275487862976 0.7056259356714012 -1.6270573251729592e-07 -0.09916363973960658 -1.8013000000000001 0.7056279956570544 0.7056263851967199 -1.6631379950136915e-07 -0.09916389274810328 -1.8014000000000001 0.7056284423541912 0.7056268346250573 -1.6989245678507292e-07 -0.0991641456803832 -1.8015 0.7056288888780742 0.705627283956129 -1.734408907241164e-07 -0.09916439853646922 -1.8016 0.7056293352290777 0.7056277331896417 -1.7695829486463754e-07 -0.09916465131638405 -1.8017 0.7056297814075847 0.7056281823252932 -1.8044387010973661e-07 -0.09916490402015044 -1.8018000000000003 0.7056302274139867 0.7056286313627733 -1.8389682491376513e-07 -0.09916515664779109 -1.8019 0.7056306732486836 0.7056290803017629 -1.8731637548355384e-07 -0.09916540919932877 -1.802 0.7056311189120835 0.7056295291419353 -1.9070174591545586e-07 -0.09916566167478624 -1.8021 0.705631564404603 0.7056299778829549 -1.9405216838616623e-07 -0.09916591407418618 -1.8022 0.7056320097266661 0.7056304265244783 -1.9736688333660268e-07 -0.0991661663975513 -1.8023000000000002 0.7056324548787059 0.7056308750661542 -2.0064513965231678e-07 -0.09916641864490441 -1.8024 0.7056328998611625 0.7056313235076228 -2.0388619479186354e-07 -0.09916667081626815 -1.8025 0.7056333446744842 0.705631771848517 -2.0708931499149874e-07 -0.09916692291166522 -1.8026000000000002 0.7056337893191273 0.7056322200884615 -2.1025377542477353e-07 -0.09916717493111832 -1.8027 0.705634233795555 0.7056326682270733 -2.1337886037253728e-07 -0.09916742687465009 -1.8028000000000002 0.705634678104239 0.7056331162639622 -2.1646386336171553e-07 -0.09916767874228323 -1.8029000000000002 0.7056351222456577 0.7056335641987306 -2.195080873422517e-07 -0.09916793053404048 -1.803 0.7056355662202973 0.7056340120309728 -2.225108448467017e-07 -0.09916818224994439 -1.8031000000000001 0.7056360100286512 0.7056344597602764 -2.2547145814635905e-07 -0.09916843389001771 -1.8032000000000001 0.7056364536712194 0.7056349073862225 -2.2838925938309385e-07 -0.0991686854542831 -1.8033000000000001 0.7056368971485096 0.7056353549083838 -2.3126359072547786e-07 -0.09916893694276319 -1.8034000000000001 0.7056373404610361 0.7056358023263267 -2.3409380454572637e-07 -0.09916918835548058 -1.8035 0.7056377836093197 0.7056362496396107 -2.368792635445982e-07 -0.09916943969245785 -1.8036 0.7056382265938889 0.7056366968477887 -2.396193408936431e-07 -0.09916969095371776 -1.8037 0.7056386694152775 0.7056371439504072 -2.423134203705102e-07 -0.09916994213928286 -1.8038000000000003 0.7056391120740266 0.7056375909470055 -2.44960896508134e-07 -0.09917019324917574 -1.8039 0.7056395545706835 0.7056380378371174 -2.475611747404516e-07 -0.09917044428341905 -1.804 0.7056399969058016 0.7056384846202695 -2.50113671509955e-07 -0.09917069524203534 -1.8041 0.7056404390799402 0.705638931295983 -2.526178144238167e-07 -0.0991709461250472 -1.8042 0.7056408810936653 0.7056393778637733 -2.550730423510339e-07 -0.09917119693247728 -1.8043000000000002 0.7056413229475482 0.7056398243231492 -2.5747880558549263e-07 -0.0991714476643482 -1.8044 0.7056417646421659 0.705640270673614 -2.598345659604595e-07 -0.09917169832068243 -1.8045 0.7056422061781011 0.7056407169146652 -2.621397969249095e-07 -0.09917194890150254 -1.8046000000000002 0.7056426475559423 0.7056411630457955 -2.643939837239373e-07 -0.09917219940683113 -1.8047 0.705643088776283 0.705641609066491 -2.665966234646766e-07 -0.09917244983669073 -1.8048000000000002 0.705643529839722 0.7056420549762334 -2.6874722527242545e-07 -0.09917270019110386 -1.8049000000000002 0.705643970746863 0.7056425007744997 -2.7084531036350445e-07 -0.0991729504700931 -1.805 0.7056444114983152 0.7056429464607608 -2.7289041215974863e-07 -0.09917320067368096 -1.8051000000000001 0.7056448520946925 0.7056433920344832 -2.7488207639952966e-07 -0.09917345080188998 -1.8052000000000001 0.7056452925366131 0.705643837495129 -2.768198612453088e-07 -0.09917370085474268 -1.8053000000000001 0.7056457328247001 0.7056442828421552 -2.7870333736690345e-07 -0.09917395083226156 -1.8054000000000001 0.7056461729595812 0.7056447280750149 -2.805320880282236e-07 -0.09917420073446914 -1.8055 0.7056466129418878 0.7056451731931561 -2.823057092295189e-07 -0.0991744505613879 -1.8056 0.7056470527722563 0.7056456181960233 -2.8402380970737884e-07 -0.0991747003130404 -1.8057 0.7056474924513261 0.7056460630830566 -2.856860111220827e-07 -0.09917494998944901 -1.8058 0.7056479319797413 0.7056465078536922 -2.8729194808188585e-07 -0.09917519959063631 -1.8059 0.7056483713581497 0.7056469525073629 -2.888412682020003e-07 -0.09917544911662468 -1.806 0.7056488105872025 0.7056473970434975 -2.903336322572503e-07 -0.09917569856743674 -1.8061 0.7056492496675542 0.7056478414615217 -2.9176871415778627e-07 -0.09917594794309485 -1.8062 0.7056496885998629 0.7056482857608571 -2.931462011329655e-07 -0.09917619724362149 -1.8063000000000002 0.7056501273847895 0.7056487299409226 -2.944657936966577e-07 -0.09917644646903905 -1.8064 0.7056505660229986 0.705649174001134 -2.957272057756144e-07 -0.09917669561937 -1.8065 0.7056510045151568 0.7056496179409044 -2.969301647545719e-07 -0.09917694469463678 -1.8066000000000002 0.7056514428619345 0.705650061759644 -2.980744115317624e-07 -0.09917719369486185 -1.8067 0.7056518810640036 0.7056505054567599 -2.991597005605473e-07 -0.09917744262006757 -1.8068000000000002 0.7056523191220394 0.7056509490316571 -3.0018579992921457e-07 -0.09917769147027639 -1.8069000000000002 0.7056527570367188 0.7056513924837386 -3.0115249139567313e-07 -0.09917794024551069 -1.807 0.7056531948087215 0.7056518358124051 -3.020595704394946e-07 -0.09917818894579289 -1.8071000000000002 0.7056536324387286 0.7056522790170544 -3.0290684628619946e-07 -0.09917843757114542 -1.8072000000000001 0.7056540699274234 0.7056527220970834 -3.0369414197317646e-07 -0.09917868612159059 -1.8073000000000001 0.7056545072754907 0.7056531650518872 -3.044212943809077e-07 -0.09917893459715083 -1.8074000000000001 0.7056549444836173 0.7056536078808586 -3.0508815423296864e-07 -0.09917918299784849 -1.8075 0.7056553815524909 0.7056540505833897 -3.056945861723559e-07 -0.09917943132370594 -1.8076 0.7056558184828007 0.705654493158871 -3.0624046878230393e-07 -0.09917967957474556 -1.8077 0.7056562552752373 0.7056549356066917 -3.0672569459322396e-07 -0.09917992775098972 -1.8078 0.7056566919304919 0.7056553779262402 -3.0715017007576506e-07 -0.09918017585246075 -1.8079 0.7056571284492565 0.7056558201169041 -3.07513815717142e-07 -0.09918042387918097 -1.808 0.7056575648322239 0.7056562621780704 -3.078165659933796e-07 -0.09918067183117273 -1.8081 0.7056580010800875 0.7056567041091251 -3.080583694387018e-07 -0.09918091970845838 -1.8082 0.7056584371935408 0.7056571459094543 -3.0823918855532595e-07 -0.09918116751106021 -1.8083000000000002 0.705658873173278 0.7056575875784437 -3.083589998620351e-07 -0.09918141523900056 -1.8084 0.7056593090199927 0.7056580291154787 -3.0841779396356683e-07 -0.09918166289230175 -1.8085 0.705659744734379 0.7056584705199449 -3.08415575453469e-07 -0.09918191047098601 -1.8086000000000002 0.7056601803171305 0.7056589117912282 -3.0835236297654944e-07 -0.09918215797507572 -1.8087 0.7056606157689405 0.705659352928715 -3.0822818915254846e-07 -0.09918240540459311 -1.8088000000000002 0.7056610510905015 0.7056597939317919 -3.0804310060389417e-07 -0.09918265275956051 -1.8089000000000002 0.7056614862825059 0.7056602347998462 -3.077971579695804e-07 -0.09918290004000019 -1.809 0.7056619213456443 0.7056606755322657 -3.0749043583577773e-07 -0.0991831472459343 -1.8091000000000002 0.7056623562806075 0.7056611161284403 -3.0712302274277237e-07 -0.09918339437738527 -1.8092000000000001 0.7056627910880842 0.7056615565877594 -3.06695021129455e-07 -0.09918364143437522 -1.8093000000000001 0.7056632257687627 0.7056619969096152 -3.0620654736801534e-07 -0.09918388841692649 -1.8094000000000001 0.7056636603233291 0.7056624370934005 -3.0565773165985854e-07 -0.09918413532506133 -1.8095 0.7056640947524682 0.7056628771385096 -3.050487180425443e-07 -0.09918438215880195 -1.8096 0.705664529056863 0.7056633170443387 -3.043796643759089e-07 -0.09918462891817058 -1.8097 0.7056649632371952 0.7056637568102857 -3.0365074222410415e-07 -0.09918487560318943 -1.8098 0.7056653972941435 0.7056641964357508 -3.028621369111084e-07 -0.09918512221388076 -1.8099 0.705665831228385 0.705664635920136 -3.020140473958266e-07 -0.09918536875026673 -1.81 0.7056662650405946 0.7056650752628459 -3.011066862304568e-07 -0.09918561521236959 -1.8101 0.7056666987314446 0.7056655144632871 -3.001402795639596e-07 -0.09918586160021152 -1.8102 0.7056671323016045 0.7056659535208691 -2.991150670171583e-07 -0.09918610791381466 -1.8103000000000002 0.7056675657517412 0.7056663924350044 -2.980313016688607e-07 -0.09918635415320129 -1.8104 0.7056679990825186 0.7056668312051078 -2.968892500003484e-07 -0.09918660031839353 -1.8105 0.7056684322945981 0.7056672698305974 -2.956891917808846e-07 -0.09918684640941355 -1.8106000000000002 0.7056688653886372 0.7056677083108942 -2.944314200364895e-07 -0.09918709242628354 -1.8107 0.7056692983652905 0.7056681466454228 -2.9311624095626487e-07 -0.09918733836902564 -1.8108000000000002 0.7056697312252088 0.7056685848336111 -2.917439738576999e-07 -0.09918758423766195 -1.8109000000000002 0.7056701639690399 0.7056690228748903 -2.903149510791181e-07 -0.09918783003221468 -1.811 0.7056705965974273 0.7056694607686963 -2.88829517906819e-07 -0.09918807575270597 -1.8111000000000002 0.7056710291110111 0.7056698985144678 -2.8728803246058643e-07 -0.09918832139915798 -1.8112000000000001 0.705671461510427 0.7056703361116476 -2.856908656867496e-07 -0.09918856697159276 -1.8113000000000001 0.7056718937963067 0.7056707735596831 -2.840384011777719e-07 -0.09918881247003247 -1.8114000000000001 0.7056723259692776 0.7056712108580256 -2.823310351375563e-07 -0.09918905789449922 -1.8115 0.7056727580299629 0.7056716480061309 -2.8056917626695377e-07 -0.09918930324501514 -1.8116 0.7056731899789807 0.7056720850034596 -2.7875324568396587e-07 -0.09918954852160229 -1.8117 0.7056736218169449 0.7056725218494763 -2.7688367679190584e-07 -0.09918979372428278 -1.8118 0.7056740535444647 0.7056729585436508 -2.749609151996013e-07 -0.0991900388530787 -1.8119 0.7056744851621437 0.7056733950854575 -2.7298541859649417e-07 -0.09919028390801204 -1.812 0.7056749166705812 0.7056738314743765 -2.709576566797822e-07 -0.09919052888910497 -1.8121 0.7056753480703712 0.7056742677098926 -2.688781110156413e-07 -0.09919077379637958 -1.8122 0.7056757793621019 0.7056747037914961 -2.667472749177946e-07 -0.09919101862985791 -1.8123000000000002 0.7056762105463563 0.7056751397186822 -2.6456565334689874e-07 -0.09919126338956195 -1.8124 0.7056766416237119 0.7056755754909527 -2.623337628029909e-07 -0.09919150807551386 -1.8125 0.7056770725947403 0.705676011107814 -2.600521311416082e-07 -0.09919175268773563 -1.8126000000000002 0.7056775034600078 0.7056764465687787 -2.5772129756337914e-07 -0.09919199722624923 -1.8127 0.7056779342200741 0.7056768818733654 -2.553418123572848e-07 -0.0991922416910768 -1.8128000000000002 0.7056783648754932 0.7056773170210981 -2.52914236848617e-07 -0.09919248608224024 -1.8129000000000002 0.7056787954268131 0.7056777520115078 -2.50439143256731e-07 -0.09919273039976162 -1.813 0.7056792258745752 0.7056781868441319 -2.4791711455973697e-07 -0.09919297464366299 -1.8131000000000002 0.7056796562193149 0.7056786215185132 -2.4534874434531395e-07 -0.09919321881396637 -1.8132000000000001 0.7056800864615607 0.7056790560342014 -2.4273463665805406e-07 -0.09919346291069366 -1.8133000000000001 0.7056805166018345 0.7056794903907533 -2.4007540589884857e-07 -0.09919370693386693 -1.8134000000000001 0.705680946640652 0.7056799245877314 -2.3737167664794612e-07 -0.09919395088350814 -1.8135 0.705681376578521 0.7056803586247056 -2.3462408352964426e-07 -0.09919419475963921 -1.8136 0.7056818064159435 0.705680792501253 -2.318332710526949e-07 -0.0991944385622822 -1.8137 0.7056822361534139 0.7056812262169574 -2.2899989349234318e-07 -0.099194682291459 -1.8138 0.7056826657914195 0.7056816597714095 -2.2612461469256884e-07 -0.09919492594719163 -1.8139 0.7056830953304407 0.7056820931642076 -2.2320810793771684e-07 -0.09919516952950204 -1.814 0.7056835247709499 0.7056825263949571 -2.202510557998416e-07 -0.09919541303841214 -1.8141 0.7056839541134126 0.705682959463271 -2.172541499478875e-07 -0.0991956564739439 -1.8142 0.7056843833582864 0.7056833923687691 -2.1421809101238032e-07 -0.09919589983611915 -1.8143000000000002 0.7056848125060216 0.70568382511108 -2.111435884258328e-07 -0.0991961431249599 -1.8144 0.7056852415570607 0.7056842576898392 -2.0803136024580282e-07 -0.0991963863404881 -1.8145 0.7056856705118382 0.7056846901046905 -2.0488213297795155e-07 -0.09919662948272562 -1.8146000000000002 0.705686099370781 0.7056851223552847 -2.0169664142338783e-07 -0.09919687255169436 -1.8147 0.7056865281343077 0.7056855544412816 -1.9847562849131806e-07 -0.09919711554741627 -1.8148000000000002 0.7056869568028286 0.7056859863623481 -1.9521984504639045e-07 -0.09919735846991312 -1.8149000000000002 0.7056873853767467 0.7056864181181601 -1.9193004971787553e-07 -0.09919760131920691 -1.815 0.705687813856456 0.7056868497084012 -1.8860700873660208e-07 -0.09919784409531948 -1.8151000000000002 0.7056882422423426 0.7056872811327638 -1.8525149573719868e-07 -0.09919808679827276 -1.8152000000000001 0.705688670534784 0.7056877123909479 -1.818642915950297e-07 -0.09919832942808855 -1.8153000000000001 0.7056890987341491 0.7056881434826623 -1.7844618423537573e-07 -0.09919857198478871 -1.8154000000000001 0.7056895268407983 0.7056885744076243 -1.7499796845649174e-07 -0.09919881446839507 -1.8155 0.7056899548550841 0.7056890051655602 -1.715204457353181e-07 -0.09919905687892955 -1.8156 0.7056903827773493 0.7056894357562046 -1.6801442405400824e-07 -0.09919929921641402 -1.8157 0.7056908106079286 0.7056898661793007 -1.6448071770043537e-07 -0.09919954148087023 -1.8158 0.7056912383471474 0.7056902964346007 -1.6092014708778135e-07 -0.09919978367232005 -1.8159 0.7056916659953225 0.7056907265218655 -1.5733353856545174e-07 -0.09920002579078524 -1.816 0.705692093552762 0.7056911564408651 -1.537217242178479e-07 -0.09920026783628771 -1.8161 0.7056925210197644 0.7056915861913784 -1.5008554168048638e-07 -0.0992005098088492 -1.8162 0.7056929483966201 0.7056920157731933 -1.4642583394917918e-07 -0.09920075170849159 -1.8163000000000002 0.7056933756836092 0.7056924451861069 -1.4274344915105042e-07 -0.09920099353523662 -1.8164 0.7056938028810031 0.7056928744299251 -1.3903924039881943e-07 -0.09920123528910603 -1.8165 0.7056942299890645 0.7056933035044637 -1.3531406556181735e-07 -0.09920147697012172 -1.8166000000000002 0.7056946570080462 0.7056937324095469 -1.3156878707863695e-07 -0.09920171857830538 -1.8167 0.7056950839381919 0.7056941611450089 -1.2780427174723108e-07 -0.09920196011367882 -1.8168000000000002 0.7056955107797361 0.7056945897106925 -1.2402139053756256e-07 -0.09920220157626376 -1.8169000000000002 0.7056959375329035 0.7056950181064505 -1.2022101836955956e-07 -0.09920244296608198 -1.817 0.7056963641979099 0.7056954463321452 -1.1640403393964327e-07 -0.09920268428315529 -1.8171000000000002 0.7056967907749612 0.705695874387648 -1.1257131949868326e-07 -0.09920292552750537 -1.8172000000000001 0.7056972172642537 0.7056963022728396 -1.0872376064383071e-07 -0.099203166699154 -1.8173000000000001 0.7056976436659748 0.7056967299876105 -1.0486224613463768e-07 -0.09920340779812284 -1.8174000000000001 0.7056980699803016 0.7056971575318608 -1.0098766766667572e-07 -0.09920364882443368 -1.8175 0.705698496207402 0.7056975849055003 -9.710091968071627e-08 -0.09920388977810825 -1.8176 0.7056989223474344 0.705698012108448 -9.32028991424208e-08 -0.09920413065916824 -1.8177 0.7056993484005468 0.7056984391406325 -8.929450535152123e-08 -0.09920437146763533 -1.8178 0.7056997743668783 0.7056988660019927 -8.537663971890791e-08 -0.09920461220353122 -1.8179 0.7057002002465582 0.7056992926924769 -8.145020557147331e-08 -0.09920485286687769 -1.818 0.705700626039706 0.7056997192120429 -7.751610793613889e-08 -0.09920509345769639 -1.8181 0.7057010517464308 0.705700145560658 -7.357525333255566e-08 -0.09920533397600893 -1.8182 0.7057014773668329 0.7057005717382998 -6.962854956797312e-08 -0.09920557442183706 -1.8183000000000002 0.7057019029010025 0.7057009977449551 -6.567690552256727e-08 -0.09920581479520241 -1.8184 0.7057023283490201 0.7057014235806212 -6.172123094691159e-08 -0.0992060550961267 -1.8185 0.7057027537109559 0.7057018492453038 -5.776243624253455e-08 -0.09920629532463146 -1.8186000000000002 0.7057031789868711 0.70570227473902 -5.380143226546216e-08 -0.09920653548073848 -1.8187 0.7057036041768168 0.7057027000617955 -4.983913010785969e-08 -0.09920677556446933 -1.8188000000000002 0.7057040292808343 0.7057031252136663 -4.587644089008164e-08 -0.09920701557584567 -1.8189000000000002 0.7057044542989548 0.7057035501946778 -4.1914275552586274e-08 -0.09920725551488913 -1.819 0.7057048792312002 0.7057039750048856 -3.795354464541066e-08 -0.09920749538162131 -1.8191000000000002 0.7057053040775827 0.7057043996443546 -3.399515811994963e-08 -0.0992077351760639 -1.8192000000000002 0.7057057288381041 0.7057048241131596 -3.004002511975898e-08 -0.0992079748982384 -1.8193000000000001 0.7057061535127573 0.7057052484113852 -2.6089053770843654e-08 -0.09920821454816653 -1.8194000000000001 0.7057065781015247 0.7057056725391253 -2.2143150973843312e-08 -0.09920845412586976 -1.8195 0.7057070026043797 0.7057060964964845 -1.8203222199985464e-08 -0.09920869363136983 -1.8196 0.7057074270212852 0.7057065202835757 -1.4270171274678722e-08 -0.09920893306468821 -1.8197 0.7057078513521952 0.7057069439005227 -1.034490017650172e-08 -0.09920917242584655 -1.8198 0.7057082755970534 0.7057073673474579 -6.428308829686813e-09 -0.09920941171486637 -1.8199 0.7057086997557942 0.7057077906245244 -2.5212948976879868e-09 -0.09920965093176926 -1.82 0.7057091238283424 0.7057082137318738 1.3752464254196406e-09 -0.09920989007657677 -1.8201 0.7057095478146134 0.7057086366696681 5.2604226148667e-09 -0.0992101291493105 -1.8202 0.7057099717145126 0.7057090594380783 9.133344023790069e-09 -0.099210368149992 -1.8203000000000003 0.7057103955279358 0.7057094820372849 1.2993124084460794e-08 -0.09921060707864268 -1.8204 0.7057108192547701 0.7057099044674782 1.6838879512114102e-08 -0.0992108459352842 -1.8205 0.7057112428948926 0.705710326728858 2.0669730509646767e-08 -0.09921108471993811 -1.8206000000000002 0.7057116664481708 0.7057107488216326 2.448480095756933e-08 -0.0992113234326258 -1.8207 0.7057120899144635 0.7057111707460209 2.8283218633448626e-08 -0.09921156207336893 -1.8208000000000002 0.7057125132936197 0.7057115925022501 3.206411539578846e-08 -0.09921180064218896 -1.8209000000000002 0.7057129365854793 0.7057120140905571 3.582662738525755e-08 -0.0992120391391074 -1.821 0.7057133597898727 0.7057124355111879 3.9569895225050056e-08 -0.09921227756414569 -1.8211000000000002 0.7057137829066218 0.7057128567643974 4.329306422211354e-08 -0.09921251591732544 -1.8212000000000002 0.7057142059355386 0.70571327785045 4.6995284549294913e-08 -0.099212754198668 -1.8213000000000001 0.7057146288764264 0.7057136987696186 5.0675711444833627e-08 -0.09921299240819491 -1.8214000000000001 0.7057150517290796 0.7057141195221859 5.433350541185489e-08 -0.09921323054592762 -1.8215 0.7057154744932834 0.705714540108443 5.796783240051562e-08 -0.09921346861188762 -1.8216 0.7057158971688144 0.7057149605286896 6.15778640040282e-08 -0.09921370660609637 -1.8217 0.7057163197554401 0.7057153807832349 6.516277764774536e-08 -0.0992139445285753 -1.8218 0.7057167422529196 0.7057158008723964 6.872175675916303e-08 -0.0992141823793459 -1.8219 0.7057171646610029 0.7057162207965001 7.225399099169971e-08 -0.09921442015842957 -1.822 0.7057175869794317 0.7057166405558809 7.575867636347433e-08 -0.09921465786584777 -1.8221 0.7057180092079389 0.7057170601508822 7.923501548108558e-08 -0.09921489550162194 -1.8222 0.7057184313462491 0.7057174795818559 8.268221769053286e-08 -0.09921513306577345 -1.8223000000000003 0.7057188533940784 0.7057178988491621 8.609949927324001e-08 -0.09921537055832376 -1.8224 0.7057192753511345 0.7057183179531696 8.94860836264666e-08 -0.09921560797929431 -1.8225 0.7057196972171169 0.7057187368942546 9.28412014211677e-08 -0.09921584532870639 -1.8226000000000002 0.7057201189917174 0.7057191556728022 9.616409079454824e-08 -0.09921608260658152 -1.8227 0.7057205406746188 0.705719574289205 9.945399753394368e-08 -0.09921631981294095 -1.8228000000000002 0.7057209622654966 0.7057199927438642 1.0271017519131176e-07 -0.09921655694780614 -1.8229000000000002 0.7057213837640184 0.7057204110371889 1.0593188533303266e-07 -0.09921679401119854 -1.823 0.7057218051698435 0.7057208291695951 1.0911839763705355e-07 -0.0992170310031394 -1.8231000000000002 0.7057222264826236 0.705721247141508 1.122689901010554e-07 -0.0992172679236502 -1.8232000000000002 0.7057226477020031 0.7057216649533588 1.153829492089864e-07 -0.09921750477275221 -1.8233000000000001 0.7057230688276187 0.7057220826055872 1.184595700420843e-07 -0.09921774155046685 -1.8234000000000001 0.7057234898590992 0.7057225000986402 1.2149815649745155e-07 -0.09921797825681541 -1.8235 0.7057239107960664 0.705722917432972 1.2449802142336375e-07 -0.09921821489181923 -1.8236 0.7057243316381351 0.7057233346090439 1.274584867511086e-07 -0.09921845145549964 -1.8237 0.7057247523849124 0.7057237516273251 1.3037888368233608e-07 -0.09921868794787803 -1.8238 0.7057251730359987 0.7057241684882908 1.3325855283824461e-07 -0.09921892436897563 -1.8239 0.7057255935909872 0.7057245851924238 1.3609684437407288e-07 -0.09921916071881381 -1.824 0.7057260140494648 0.7057250017402138 1.3889311816991934e-07 -0.09921939699741394 -1.8241 0.7057264344110102 0.7057254181321568 1.416467439278868e-07 -0.09921963320479718 -1.8242 0.7057268546751975 0.7057258343687557 1.4435710136290192e-07 -0.09921986934098495 -1.8243000000000003 0.7057272748415926 0.7057262504505197 1.470235803102682e-07 -0.09922010540599846 -1.8244 0.7057276949097557 0.7057266663779652 1.4964558086097424e-07 -0.09922034139985908 -1.8245 0.7057281148792407 0.7057270821516135 1.522225135386357e-07 -0.09922057732258799 -1.8246000000000002 0.705728534749595 0.7057274977719932 1.54753799375823e-07 -0.09922081317420652 -1.8247 0.7057289545203602 0.7057279132396385 1.57238870073656e-07 -0.09922104895473592 -1.8248000000000002 0.7057293741910716 0.7057283285550896 1.5967716813364285e-07 -0.09922128466419743 -1.8249000000000002 0.705729793761259 0.7057287437188927 1.6206814695135519e-07 -0.0992215203026123 -1.825 0.7057302132304466 0.7057291587315997 1.6441127098643094e-07 -0.09922175587000186 -1.8251000000000002 0.7057306325981523 0.7057295735937676 1.6670601583196332e-07 -0.09922199136638722 -1.8252000000000002 0.7057310518638888 0.7057299883059597 1.689518683914426e-07 -0.09922222679178971 -1.8253000000000001 0.7057314710271638 0.7057304028687439 1.711483269342673e-07 -0.09922246214623051 -1.8254000000000001 0.7057318900874794 0.7057308172826939 1.732949012310525e-07 -0.09922269742973085 -1.8255 0.7057323090443327 0.7057312315483883 1.7539111268199958e-07 -0.09922293264231197 -1.8256000000000001 0.7057327278972154 0.7057316456664103 1.7743649439322384e-07 -0.09922316778399502 -1.8257 0.7057331466456152 0.7057320596373486 1.7943059129471584e-07 -0.09922340285480129 -1.8258 0.705733565289014 0.7057324734617962 1.8137296023748584e-07 -0.09922363785475186 -1.8259 0.7057339838268901 0.7057328871403507 1.832631701011167e-07 -0.09922387278386806 -1.826 0.7057344022587166 0.7057333006736142 1.851008018839695e-07 -0.09922410764217093 -1.8261 0.7057348205839625 0.7057337140621933 1.8688544877604185e-07 -0.09922434242968176 -1.8262 0.7057352388020928 0.7057341273066988 1.8861671627345977e-07 -0.09922457714642173 -1.8263000000000003 0.7057356569125678 0.7057345404077454 1.902942222756221e-07 -0.0992248117924119 -1.8264 0.7057360749148444 0.7057349533659516 1.919175971580589e-07 -0.09922504636767349 -1.8265 0.7057364928083752 0.70573536618194 1.9348648380712596e-07 -0.09922528087222764 -1.8266000000000002 0.7057369105926099 0.7057357788563369 1.9500053779347715e-07 -0.09922551530609552 -1.8267 0.7057373282669938 0.7057361913897716 1.9645942735124766e-07 -0.09922574966929822 -1.8268000000000002 0.705737745830969 0.7057366037828776 1.9786283352030143e-07 -0.0992259839618569 -1.8269000000000002 0.7057381632839748 0.705737016036291 1.9921045018786443e-07 -0.09922621818379271 -1.827 0.705738580625447 0.7057374281506512 2.0050198412321918e-07 -0.09922645233512677 -1.8271000000000002 0.7057389978548183 0.7057378401266007 2.017371551095437e-07 -0.09922668641588016 -1.8272 0.7057394149715188 0.7057382519647846 2.0291569597166714e-07 -0.09922692042607399 -1.8273000000000001 0.7057398319749758 0.7057386636658511 2.0403735261423361e-07 -0.09922715436572943 -1.8274000000000001 0.7057402488646138 0.7057390752304504 2.0510188408762176e-07 -0.09922738823486749 -1.8275 0.7057406656398553 0.7057394866592356 2.0610906266774198e-07 -0.09922762203350932 -1.8276000000000001 0.7057410823001198 0.7057398979528615 2.0705867385256704e-07 -0.0992278557616759 -1.8277 0.7057414988448256 0.7057403091119857 2.0795051647662377e-07 -0.09922808941938843 -1.8278 0.7057419152733881 0.7057407201372675 2.0878440266589027e-07 -0.09922832300666795 -1.8279 0.705742331585222 0.7057411310293682 2.095601579696349e-07 -0.09922855652353554 -1.828 0.7057427477797389 0.7057415417889502 2.1027762132225236e-07 -0.09922878997001226 -1.8281 0.7057431638563494 0.7057419524166779 2.1093664510571375e-07 -0.09922902334611908 -1.8282 0.705743579814463 0.7057423629132173 2.1153709520507769e-07 -0.09922925665187711 -1.8283000000000003 0.7057439956534877 0.7057427732792353 2.1207885097379586e-07 -0.09922948988730741 -1.8284 0.7057444113728301 0.7057431835153999 2.1256180532391866e-07 -0.09922972305243097 -1.8285 0.7057448269718961 0.7057435936223803 2.1298586471221737e-07 -0.09922995614726883 -1.8286000000000002 0.7057452424500905 0.7057440036008464 2.1335094914712305e-07 -0.099230189171842 -1.8287 0.705745657806818 0.7057444134514692 2.1365699220954326e-07 -0.09923042212617154 -1.8288000000000002 0.705746073041482 0.7057448231749193 2.139039411014343e-07 -0.09923065501027845 -1.8289000000000002 0.7057464881534857 0.7057452327718686 2.1409175661457613e-07 -0.0992308878241837 -1.829 0.7057469031422324 0.7057456422429887 2.1422041314098084e-07 -0.09923112056790828 -1.8291000000000002 0.7057473180071249 0.7057460515889518 2.1428989869023973e-07 -0.09923135324147325 -1.8292 0.7057477327475661 0.7057464608104294 2.1430021484789008e-07 -0.09923158584489956 -1.8293000000000001 0.7057481473629591 0.7057468699080931 2.1425137684133455e-07 -0.09923181837820816 -1.8294000000000001 0.7057485618527073 0.7057472788826145 2.141434134635134e-07 -0.09923205084142002 -1.8295 0.7057489762162149 0.705747687734664 2.1397636710412948e-07 -0.09923228323455616 -1.8296000000000001 0.705749390452886 0.7057480964649123 2.1375029370454546e-07 -0.0992325155576375 -1.8297 0.7057498045621262 0.7057485050740284 2.13465262775131e-07 -0.09923274781068502 -1.8298 0.7057502185433414 0.7057489135626807 2.1312135737444615e-07 -0.0992329799937196 -1.8299 0.7057506323959389 0.7057493219315372 2.127186740225051e-07 -0.09923321210676228 -1.83 0.7057510461193273 0.7057497301812632 2.1225732278057352e-07 -0.09923344414983391 -1.8301 0.705751459712916 0.7057501383125244 2.1173742711239063e-07 -0.09923367612295549 -1.8302 0.7057518731761161 0.7057505463259836 2.1115912392927205e-07 -0.09923390802614789 -1.8303000000000003 0.705752286508341 0.7057509542223028 2.1052256352072085e-07 -0.09923413985943207 -1.8304 0.7057526997090049 0.7057513620021417 2.098279095370803e-07 -0.09923437162282889 -1.8305 0.7057531127775244 0.7057517696661585 2.0907533894096164e-07 -0.0992346033163593 -1.8306000000000002 0.7057535257133178 0.705752177215009 2.0826504191356898e-07 -0.09923483494004418 -1.8307 0.7057539385158063 0.7057525846493469 2.0739722188592435e-07 -0.09923506649390444 -1.8308000000000002 0.7057543511844124 0.7057529919698236 2.0647209546947876e-07 -0.09923529797796092 -1.8309000000000002 0.7057547637185624 0.7057533991770878 2.0548989232774262e-07 -0.09923552939223454 -1.831 0.7057551761176837 0.7057538062717859 2.0445085521444972e-07 -0.09923576073674616 -1.8311000000000002 0.7057555883812074 0.7057542132545613 2.0335523988335158e-07 -0.09923599201151666 -1.8312 0.7057560005085677 0.7057546201260547 2.022033150188285e-07 -0.09923622321656692 -1.8313000000000001 0.7057564124992008 0.7057550268869033 2.0099536215262281e-07 -0.0992364543519177 -1.8314000000000001 0.7057568243525473 0.7057554335377414 1.9973167561179728e-07 -0.09923668541758995 -1.8315 0.7057572360680499 0.7057558400792001 1.9841256245628491e-07 -0.09923691641360446 -1.8316000000000001 0.7057576476451559 0.7057562465119069 1.9703834240603069e-07 -0.09923714733998214 -1.8317 0.7057580590833152 0.7057566528364858 1.9560934774731642e-07 -0.09923737819674373 -1.8318 0.7057584703819819 0.7057570590535571 1.9412592324602462e-07 -0.09923760898391015 -1.8319 0.705758881540614 0.7057574651637369 1.925884260886579e-07 -0.09923783970150214 -1.832 0.7057592925586731 0.7057578711676374 1.909972257990722e-07 -0.09923807034954052 -1.8321 0.7057597034356252 0.7057582770658672 1.8935270413092398e-07 -0.09923830092804614 -1.8322 0.7057601141709403 0.7057586828590301 1.876552549705257e-07 -0.09923853143703971 -1.8323000000000003 0.705760524764093 0.7057590885477256 1.859052842743958e-07 -0.09923876187654213 -1.8324 0.7057609352145625 0.7057594941325489 1.8410320993395013e-07 -0.09923899224657415 -1.8325 0.7057613455218321 0.7057598996140906 1.8224946169917433e-07 -0.09923922254715656 -1.8326000000000002 0.7057617556853903 0.7057603049929362 1.8034448106760137e-07 -0.09923945277831012 -1.8327 0.7057621657047303 0.7057607102696664 1.7838872121492266e-07 -0.09923968294005561 -1.8328000000000002 0.7057625755793503 0.705761115444857 1.7638264681804627e-07 -0.09923991303241378 -1.8329000000000002 0.7057629853087535 0.7057615205190786 1.7432673402040244e-07 -0.09924014305540539 -1.833 0.7057633948924485 0.705761925492897 1.72221470241124e-07 -0.0992403730090512 -1.8331000000000002 0.7057638043299493 0.7057623303668717 1.7006735410912688e-07 -0.09924060289337196 -1.8332 0.7057642136207751 0.7057627351415576 1.6786489533821003e-07 -0.0992408327083884 -1.8333000000000002 0.7057646227644512 0.7057631398175033 1.65614614622972e-07 -0.09924106245412125 -1.8334000000000001 0.7057650317605078 0.7057635443952521 1.633170435104414e-07 -0.09924129213059124 -1.8335 0.7057654406084816 0.7057639488753417 1.609727242127268e-07 -0.09924152173781911 -1.8336000000000001 0.7057658493079149 0.7057643532583027 1.5858220956191382e-07 -0.09924175127582552 -1.8337 0.7057662578583563 0.705764757544661 1.5614606283659294e-07 -0.0992419807446312 -1.8338 0.7057666662593605 0.7057651617349354 1.536648576404287e-07 -0.09924221014425685 -1.8339 0.705767074510488 0.7057655658296389 1.5113917775991248e-07 -0.09924243947472318 -1.834 0.7057674826113065 0.7057659698292783 1.4856961705334015e-07 -0.0992426687360509 -1.8341 0.7057678905613894 0.7057663737343531 1.4595677925652306e-07 -0.09924289792826066 -1.8342 0.7057682983603174 0.7057667775453571 1.4330127790299074e-07 -0.0992431270513732 -1.8343000000000003 0.7057687060076773 0.7057671812627765 1.4060373615051858e-07 -0.09924335610540913 -1.8344 0.7057691135030626 0.7057675848870911 1.3786478663194157e-07 -0.09924358509038908 -1.8345 0.7057695208460744 0.7057679884187742 1.3508507129902925e-07 -0.09924381400633381 -1.8346000000000002 0.7057699280363201 0.7057683918582918 1.3226524131146333e-07 -0.09924404285326392 -1.8347 0.7057703350734147 0.7057687952061023 1.2940595684254874e-07 -0.09924427163120005 -1.8348000000000002 0.70577074195698 0.7057691984626575 1.2650788693696624e-07 -0.09924450034016291 -1.8349000000000002 0.7057711486866449 0.7057696016284019 1.2357170936852513e-07 -0.09924472898017306 -1.835 0.7057715552620465 0.705770004703772 1.2059811045628255e-07 -0.09924495755125112 -1.8351000000000002 0.7057719616828284 0.7057704076891979 1.1758778494311284e-07 -0.09924518605341777 -1.8352 0.7057723679486424 0.7057708105851009 1.1454143578407128e-07 -0.09924541448669362 -1.8353000000000002 0.7057727740591473 0.7057712133918956 1.1145977402149398e-07 -0.09924564285109926 -1.8354000000000001 0.7057731800140106 0.7057716161099886 1.0834351860111724e-07 -0.09924587114665531 -1.8355 0.7057735858129062 0.7057720187397781 1.0519339621942181e-07 -0.09924609937338232 -1.8356000000000001 0.7057739914555172 0.7057724212816556 1.0201014112240503e-07 -0.09924632753130094 -1.8357 0.7057743969415338 0.7057728237360037 9.879449496333348e-08 -0.09924655562043173 -1.8358 0.7057748022706547 0.705773226103197 9.554720663274008e-08 -0.09924678364079531 -1.8359 0.7057752074425866 0.7057736283836025 9.226903206066561e-08 -0.09924701159241224 -1.836 0.705775612457044 0.7057740305775784 8.896073407441141e-08 -0.09924723947530306 -1.8361 0.7057760173137504 0.7057744326854749 8.562308217302528e-08 -0.09924746728948834 -1.8362 0.7057764220124367 0.7057748347076339 8.225685240240144e-08 -0.09924769503498865 -1.8363000000000003 0.7057768265528431 0.7057752366443888 7.886282712456227e-08 -0.09924792271182452 -1.8364 0.7057772309347177 0.7057756384960647 7.544179486673741e-08 -0.09924815032001653 -1.8365 0.7057776351578171 0.705776040262978 7.19945501513608e-08 -0.09924837785958521 -1.8366000000000002 0.7057780392219068 0.7057764419454362 6.852189326708724e-08 -0.09924860533055105 -1.8367 0.7057784431267606 0.7057768435437388 6.502463011613668e-08 -0.0992488327329346 -1.8368000000000002 0.7057788468721616 0.7057772450581763 6.15035720182705e-08 -0.09924906006675645 -1.8369000000000002 0.7057792504579008 0.70577764648903 5.7959535530380246e-08 -0.099249287332037 -1.837 0.7057796538837784 0.7057780478365729 5.439334224352499e-08 -0.09924951452879681 -1.8371000000000002 0.7057800571496035 0.705778449101069 5.080581859731592e-08 -0.09924974165705638 -1.8372 0.7057804602551943 0.7057788502827735 4.719779569603566e-08 -0.09924996871683622 -1.8373000000000002 0.7057808632003775 0.7057792513819321 4.3570109102206156e-08 -0.09925019570815678 -1.8374000000000001 0.7057812659849892 0.7057796523987819 3.992359866658579e-08 -0.09925042263103857 -1.8375 0.7057816686088744 0.7057800533335512 3.625910830265533e-08 -0.0992506494855021 -1.8376000000000001 0.7057820710718872 0.7057804541864585 3.257748581488029e-08 -0.0992508762715678 -1.8377000000000001 0.7057824733738907 0.7057808549577136 2.887958269748303e-08 -0.09925110298925616 -1.8378 0.7057828755147575 0.7057812556475171 2.5166253924541193e-08 -0.09925132963858763 -1.8379 0.7057832774943686 0.7057816562560602 2.1438357779984818e-08 -0.09925155621958263 -1.838 0.7057836793126158 0.7057820567835249 1.7696755628612837e-08 -0.0992517827322617 -1.8381 0.705784080969398 0.7057824572300844 1.3942311740018642e-08 -0.09925200917664521 -1.8382 0.7057844824646254 0.7057828575959014 1.0175893074351738e-08 -0.09925223555275359 -1.8383000000000003 0.7057848837982164 0.7057832578811307 6.3983690906307955e-09 -0.09925246186060731 -1.8384 0.7057852849700987 0.7057836580859168 2.6106115429136434e-09 -0.09925268810022678 -1.8385 0.70578568598021 0.7057840582103949 -1.1865057209306529e-09 -0.09925291427163235 -1.8386000000000002 0.7057860868284969 0.7057844582546913 -4.9921069587149924e-09 -0.09925314037484456 -1.8387 0.7057864875149157 0.7057848582189221 -8.805314738631609e-09 -0.09925336640988372 -1.8388000000000002 0.7057868880394318 0.7057852581031949 -1.262525013917895e-08 -0.09925359237677027 -1.8389000000000002 0.70578728840202 0.705785657907607 -1.645103295342537e-08 -0.09925381827552454 -1.839 0.7057876886026654 0.7057860576322466 -2.028178188980337e-08 -0.099254044106167 -1.8391000000000002 0.7057880886413614 0.7057864572771926 -2.4116614774638556e-08 -0.09925426986871802 -1.8392 0.7057884885181115 0.7057868568425143 -2.7954648760750156e-08 -0.09925449556319797 -1.8393000000000002 0.7057888882329284 0.7057872563282714 -3.179500052325791e-08 -0.09925472118962719 -1.8394000000000001 0.7057892877858344 0.705787655734514 -3.5636786468833115e-08 -0.09925494674802607 -1.8395 0.7057896871768613 0.7057880550612832 -3.9479122931939184e-08 -0.09925517223841498 -1.8396000000000001 0.7057900864060501 0.7057884543086097 -4.332112638560058e-08 -0.0992553976608142 -1.8397000000000001 0.7057904854734518 0.7057888534765158 -4.7161913642034415e-08 -0.09925562301524415 -1.8398 0.7057908843791263 0.705789252565014 -5.1000602051005234e-08 -0.09925584830172518 -1.8399 0.705791283123143 0.7057896515741069 -5.483630970961814e-08 -0.09925607352027754 -1.84 0.7057916817055812 0.7057900505037876 -5.86681556601857e-08 -0.09925629867092162 -1.8401 0.7057920801265289 0.7057904493540407 -6.249526009454581e-08 -0.09925652375367772 -1.8402 0.7057924783860845 0.7057908481248405 -6.631674455415126e-08 -0.09925674876856616 -1.8403000000000003 0.7057928764843548 0.705791246816152 -7.013173213346602e-08 -0.09925697371560728 -1.8404 0.7057932744214566 0.7057916454279312 -7.393934767837423e-08 -0.09925719859482136 -1.8405 0.7057936721975157 0.705792043960124 -7.77387179949976e-08 -0.09925742340622869 -1.8406000000000002 0.7057940698126673 0.7057924424126683 -8.152897203791282e-08 -0.09925764814984961 -1.8407 0.7057944672670561 0.7057928407854909 -8.530924111571636e-08 -0.09925787282570434 -1.8408000000000002 0.7057948645608358 0.7057932390785105 -8.907865909485446e-08 -0.09925809743381316 -1.8409 0.7057952616941696 0.7057936372916367 -9.283636259131006e-08 -0.0992583219741964 -1.841 0.7057956586672298 0.7057940354247687 -9.658149116489184e-08 -0.0992585464468743 -1.8411000000000002 0.7057960554801976 0.7057944334777977 -1.0031318752740104e-07 -0.0992587708518671 -1.8412 0.705796452133264 0.7057948314506048 -1.040305977317163e-07 -0.09925899518919508 -1.8413000000000002 0.7057968486266286 0.705795229343063 -1.0773287136955217e-07 -0.0992592194588785 -1.8414000000000001 0.7057972449605002 0.7057956271550353 -1.1141916175794186e-07 -0.09925944366093763 -1.8415 0.7057976411350961 0.7057960248863759 -1.1508862615174087e-07 -0.09925966779539261 -1.8416000000000001 0.7057980371506436 0.7057964225369304 -1.1874042590322154e-07 -0.0992598918622637 -1.8417000000000001 0.7057984330073781 0.7057968201065349 -1.2237372670059754e-07 -0.09926011586157119 -1.8418 0.7057988287055446 0.7057972175950169 -1.2598769871634274e-07 -0.09926033979333526 -1.8419 0.7057992242453961 0.7057976150021953 -1.2958151681188856e-07 -0.09926056365757617 -1.842 0.7057996196271947 0.7057980123278795 -1.3315436073538245e-07 -0.09926078745431403 -1.8421 0.7058000148512116 0.7057984095718707 -1.367054152934255e-07 -0.09926101118356913 -1.8422 0.7058004099177264 0.7057988067339611 -1.402338705523004e-07 -0.09926123484536163 -1.8423000000000003 0.7058008048270272 0.7057992038139348 -1.4373892199930072e-07 -0.09926145843971175 -1.8424 0.7058011995794108 0.7057996008115667 -1.4721977075263237e-07 -0.09926168196663966 -1.8425 0.7058015941751822 0.7057999977266236 -1.5067562373141663e-07 -0.09926190542616553 -1.8426000000000002 0.7058019886146552 0.7058003945588636 -1.5410569383436656e-07 -0.09926212881830951 -1.8427 0.7058023828981519 0.7058007913080364 -1.5750920011499414e-07 -0.09926235214309181 -1.8428000000000002 0.7058027770260022 0.7058011879738837 -1.6088536797589925e-07 -0.09926257540053257 -1.8429 0.7058031709985451 0.705801584556139 -1.6423342933183371e-07 -0.09926279859065196 -1.843 0.7058035648161267 0.7058019810545271 -1.6755262278317362e-07 -0.09926302171347007 -1.8431000000000002 0.7058039584791022 0.7058023774687652 -1.7084219379980004e-07 -0.09926324476900712 -1.8432 0.7058043519878339 0.7058027737985624 -1.7410139488242826e-07 -0.09926346775728319 -1.8433000000000002 0.7058047453426926 0.7058031700436197 -1.773294857274066e-07 -0.09926369067831847 -1.8434000000000001 0.7058051385440568 0.7058035662036304 -1.805257334210053e-07 -0.09926391353213308 -1.8435 0.7058055315923126 0.7058039622782799 -1.8368941257299043e-07 -0.09926413631874707 -1.8436000000000001 0.7058059244878538 0.7058043582672457 -1.8681980549009602e-07 -0.0992643590381806 -1.8437000000000001 0.7058063172310822 0.7058047541701984 -1.8991620237551743e-07 -0.09926458169045375 -1.8438 0.7058067098224066 0.7058051499868003 -1.9297790142605575e-07 -0.09926480427558666 -1.8439 0.7058071022622434 0.7058055457167067 -1.960042090333458e-07 -0.09926502679359943 -1.844 0.7058074945510162 0.7058059413595656 -1.9899443995732846e-07 -0.09926524924451212 -1.8441 0.7058078866891562 0.7058063369150172 -2.0194791741645624e-07 -0.09926547162834481 -1.8442 0.7058082786771012 0.7058067323826951 -2.0486397330279904e-07 -0.09926569394511754 -1.8443000000000003 0.7058086705152964 0.7058071277622258 -2.0774194831388315e-07 -0.09926591619485048 -1.8444 0.7058090622041941 0.7058075230532286 -2.1058119207412185e-07 -0.09926613837756366 -1.8445 0.7058094537442532 0.7058079182553161 -2.13381063325635e-07 -0.09926636049327714 -1.8446000000000002 0.7058098451359394 0.7058083133680939 -2.1614093005314916e-07 -0.09926658254201098 -1.8447 0.7058102363797247 0.705808708391161 -2.188601696123671e-07 -0.09926680452378517 -1.8448000000000002 0.7058106274760884 0.7058091033241098 -2.215381688999707e-07 -0.09926702643861979 -1.8449 0.7058110184255155 0.7058094981665268 -2.2417432447158214e-07 -0.09926724828653488 -1.845 0.705811409228498 0.7058098929179912 -2.267680426909502e-07 -0.09926747006755048 -1.8451000000000002 0.7058117998855336 0.705810287578077 -2.2931873982362516e-07 -0.09926769178168662 -1.8452 0.7058121903971264 0.7058106821463508 -2.3182584223818692e-07 -0.09926791342896328 -1.8453000000000002 0.7058125807637864 0.7058110766223742 -2.342887864686949e-07 -0.09926813500940052 -1.8454000000000002 0.7058129709860297 0.7058114710057022 -2.3670701938469096e-07 -0.0992683565230183 -1.8455 0.7058133610643779 0.7058118652958846 -2.3907999829875237e-07 -0.09926857796983665 -1.8456000000000001 0.7058137509993583 0.705812259492465 -2.4140719108445285e-07 -0.09926879934987554 -1.8457000000000001 0.7058141407915041 0.7058126535949817 -2.43688076287385e-07 -0.09926902066315496 -1.8458 0.7058145304413539 0.7058130476029674 -2.459221432778158e-07 -0.09926924190969494 -1.8459 0.7058149199494513 0.7058134415159492 -2.4810889233742306e-07 -0.0992694630895154 -1.846 0.7058153093163454 0.7058138353334498 -2.502478347772563e-07 -0.09926968420263638 -1.8461 0.7058156985425901 0.7058142290549857 -2.5233849302100375e-07 -0.09926990524907775 -1.8462 0.7058160876287444 0.7058146226800694 -2.543804007576478e-07 -0.09927012622885956 -1.8463000000000003 0.7058164765753725 0.7058150162082077 -2.563731030316707e-07 -0.09927034714200174 -1.8464 0.7058168653830428 0.7058154096389033 -2.5831615631244365e-07 -0.09927056798852421 -1.8465 0.7058172540523286 0.7058158029716537 -2.6020912862259604e-07 -0.09927078876844692 -1.8466000000000002 0.7058176425838076 0.7058161962059525 -2.620515996316908e-07 -0.09927100948178981 -1.8467 0.7058180309780621 0.7058165893412883 -2.638431607429603e-07 -0.09927123012857285 -1.8468000000000002 0.705818419235678 0.7058169823771461 -2.6558341521126794e-07 -0.09927145070881593 -1.8469 0.7058188073572458 0.7058173753130061 -2.6727197815698545e-07 -0.09927167122253892 -1.847 0.7058191953433601 0.7058177681483451 -2.6890847674293505e-07 -0.0992718916697618 -1.8471000000000002 0.7058195831946188 0.7058181608826356 -2.7049255019173657e-07 -0.09927211205050446 -1.8472 0.7058199709116241 0.7058185535153467 -2.720238498829519e-07 -0.09927233236478678 -1.8473000000000002 0.7058203584949814 0.7058189460459436 -2.7350203946410745e-07 -0.09927255261262867 -1.8474000000000002 0.7058207459452994 0.7058193384738886 -2.749267948472245e-07 -0.09927277279405002 -1.8475 0.7058211332631907 0.7058197307986398 -2.7629780436494444e-07 -0.09927299290907073 -1.8476000000000001 0.7058215204492705 0.7058201230196529 -2.776147687705288e-07 -0.09927321295771063 -1.8477000000000001 0.7058219075041574 0.7058205151363801 -2.7887740135928984e-07 -0.09927343293998965 -1.8478 0.7058222944284728 0.7058209071482708 -2.800854279928766e-07 -0.09927365285592767 -1.8479 0.7058226812228408 0.7058212990547714 -2.81238587168664e-07 -0.09927387270554448 -1.848 0.7058230678878881 0.7058216908553261 -2.8233663007873333e-07 -0.09927409248885996 -1.8481 0.7058234544242439 0.705822082549376 -2.833793206584445e-07 -0.09927431220589393 -1.8482 0.7058238408325402 0.7058224741363601 -2.8436643563153896e-07 -0.09927453185666626 -1.8483000000000003 0.7058242271134108 0.7058228656157153 -2.8529776458993683e-07 -0.09927475144119682 -1.8484 0.7058246132674916 0.7058232569868765 -2.8617310999720647e-07 -0.09927497095950545 -1.8485 0.7058249992954204 0.7058236482492761 -2.8699228725101444e-07 -0.09927519041161187 -1.8486000000000002 0.7058253851978371 0.705824039402345 -2.877551247212895e-07 -0.099275409797536 -1.8487 0.7058257709753832 0.7058244304455124 -2.8846146376063087e-07 -0.09927562911729765 -1.8488000000000002 0.7058261566287014 0.7058248213782058 -2.891111588118611e-07 -0.09927584837091658 -1.8489 0.7058265421584361 0.7058252121998514 -2.8970407733863723e-07 -0.09927606755841258 -1.849 0.705826927565233 0.7058256029098742 -2.9024009991565625e-07 -0.0992762866798055 -1.8491000000000002 0.7058273128497388 0.705825993507698 -2.9071912024600244e-07 -0.0992765057351151 -1.8492 0.7058276980126008 0.7058263839927454 -2.911410451333918e-07 -0.09927672472436115 -1.8493000000000002 0.7058280830544679 0.7058267743644386 -2.9150579456196923e-07 -0.09927694364756343 -1.8494000000000002 0.7058284679759889 0.7058271646221987 -2.9181330170671704e-07 -0.09927716250474171 -1.8495 0.7058288527778137 0.7058275547654467 -2.9206351287794363e-07 -0.09927738129591579 -1.8496000000000001 0.7058292374605925 0.7058279447936024 -2.922563876184281e-07 -0.0992776000211054 -1.8497000000000001 0.7058296220249756 0.7058283347060861 -2.923918986375007e-07 -0.09927781868033032 -1.8498 0.7058300064716136 0.7058287245023174 -2.924700318596152e-07 -0.09927803727361031 -1.8499 0.7058303908011567 0.7058291141817163 -2.924907863965931e-07 -0.09927825580096505 -1.85 0.7058307750142555 0.7058295037437027 -2.924541745788489e-07 -0.09927847426241433 -1.8501 0.7058311591115598 0.705829893187697 -2.923602218721233e-07 -0.09927869265797785 -1.8502 0.7058315430937193 0.70583028251312 -2.922089669607497e-07 -0.0992789109876754 -1.8503000000000003 0.7058319269613829 0.7058306717193924 -2.92000461688674e-07 -0.09927912925152661 -1.8504 0.7058323107151989 0.7058310608059366 -2.917347710212903e-07 -0.09927934744955125 -1.8505 0.7058326943558145 0.7058314497721754 -2.914119730974829e-07 -0.099279565581769 -1.8506000000000002 0.7058330778838764 0.7058318386175325 -2.9103215910819547e-07 -0.09927978364819962 -1.8507 0.7058334613000297 0.7058322273414329 -2.9059543337969784e-07 -0.09928000164886275 -1.8508000000000002 0.7058338446049182 0.7058326159433027 -2.901019132660332e-07 -0.09928021958377808 -1.8509 0.7058342277991847 0.7058330044225696 -2.8955172916289573e-07 -0.09928043745296537 -1.851 0.7058346108834698 0.7058333927786625 -2.889450244382419e-07 -0.0992806552564442 -1.8511000000000002 0.7058349938584129 0.7058337810110122 -2.8828195542188184e-07 -0.09928087299423423 -1.8512 0.7058353767246512 0.7058341691190517 -2.875626913603768e-07 -0.09928109066635521 -1.8513000000000002 0.7058357594828204 0.7058345571022155 -2.867874143719362e-07 -0.09928130827282677 -1.8514000000000002 0.7058361421335535 0.7058349449599404 -2.859563193770287e-07 -0.09928152581366857 -1.8515 0.7058365246774818 0.7058353326916651 -2.850696141018516e-07 -0.09928174328890027 -1.8516000000000001 0.705836907115234 0.7058357202968311 -2.841275189811865e-07 -0.09928196069854152 -1.8517000000000001 0.7058372894474356 0.705836107774882 -2.8313026714105183e-07 -0.0992821780426119 -1.8518000000000001 0.7058376716747108 0.7058364951252647 -2.8207810429461966e-07 -0.09928239532113109 -1.8519 0.7058380537976797 0.7058368823474284 -2.80971288745685e-07 -0.09928261253411876 -1.852 0.7058384358169603 0.7058372694408248 -2.798100912221324e-07 -0.09928282968159444 -1.8521 0.705838817733167 0.7058376564049096 -2.7859479494185546e-07 -0.0992830467635778 -1.8522 0.7058391995469113 0.7058380432391409 -2.773256954462233e-07 -0.09928326378008843 -1.8523000000000003 0.7058395812588014 0.7058384299429807 -2.760031005619168e-07 -0.09928348073114594 -1.8524 0.7058399628694421 0.705838816515894 -2.7462733032113107e-07 -0.09928369761676993 -1.8525 0.7058403443794339 0.7058392029573493 -2.731987169234118e-07 -0.09928391443697998 -1.8526000000000002 0.7058407257893746 0.7058395892668192 -2.7171760456912164e-07 -0.0992841311917957 -1.8527 0.7058411070998576 0.7058399754437801 -2.7018434947331804e-07 -0.09928434788123663 -1.8528000000000002 0.7058414883114725 0.705840361487712 -2.6859931970962814e-07 -0.09928456450532241 -1.8529 0.7058418694248043 0.7058407473980992 -2.6696289515126814e-07 -0.09928478106407251 -1.853 0.7058422504404347 0.7058411331744303 -2.652754673704294e-07 -0.09928499755750661 -1.8531000000000002 0.7058426313589401 0.7058415188161979 -2.635374395758283e-07 -0.09928521398564417 -1.8532 0.7058430121808932 0.7058419043228996 -2.6174922646352017e-07 -0.09928543034850483 -1.8533000000000002 0.7058433929068616 0.7058422896940368 -2.5991125415444905e-07 -0.09928564664610805 -1.8534000000000002 0.7058437735374085 0.7058426749291167 -2.5802396009730333e-07 -0.09928586287847344 -1.8535 0.7058441540730918 0.70584306002765 -2.560877929297378e-07 -0.09928607904562048 -1.8536000000000001 0.7058445345144647 0.7058434449891534 -2.5410321241245426e-07 -0.09928629514756875 -1.8537000000000001 0.7058449148620756 0.7058438298131482 -2.5207068930777066e-07 -0.0992865111843377 -1.8538000000000001 0.7058452951164672 0.705844214499161 -2.499907052443129e-07 -0.09928672715594691 -1.8539 0.7058456752781774 0.7058445990467233 -2.4786375261293125e-07 -0.09928694306241587 -1.854 0.7058460553477386 0.7058449834553726 -2.4569033448690325e-07 -0.0992871589037641 -1.8541 0.7058464353256773 0.7058453677246515 -2.4347096446233896e-07 -0.09928737468001109 -1.8542 0.7058468152125147 0.7058457518541084 -2.412061665436893e-07 -0.09928759039117634 -1.8543000000000003 0.7058471950087659 0.7058461358432975 -2.3889647503619327e-07 -0.09928780603727934 -1.8544 0.7058475747149404 0.7058465196917785 -2.365424343932221e-07 -0.09928802161833955 -1.8545 0.7058479543315417 0.7058469033991177 -2.3414459911566543e-07 -0.09928823713437648 -1.8546 0.705848333859067 0.7058472869648864 -2.3170353362009233e-07 -0.09928845258540953 -1.8547 0.7058487132980078 0.7058476703886634 -2.2921981207915665e-07 -0.09928866797145826 -1.8548000000000002 0.7058490926488487 0.7058480536700327 -2.2669401832098313e-07 -0.09928888329254205 -1.8549 0.7058494719120685 0.7058484368085852 -2.2412674564528667e-07 -0.09928909854868043 -1.855 0.7058498510881392 0.705848819803918 -2.2151859674704455e-07 -0.0992893137398928 -1.8551000000000002 0.7058502301775262 0.7058492026556351 -2.1887018351873788e-07 -0.09928952886619863 -1.8552 0.7058506091806884 0.7058495853633466 -2.1618212693585992e-07 -0.09928974392761733 -1.8553000000000002 0.7058509880980777 0.7058499679266699 -2.1345505691119926e-07 -0.09928995892416834 -1.8554000000000002 0.7058513669301392 0.7058503503452287 -2.1068961215259252e-07 -0.09929017385587105 -1.8555 0.7058517456773111 0.7058507326186545 -2.078864399755742e-07 -0.09929038872274497 -1.8556000000000001 0.7058521243400244 0.705851114746585 -2.0504619619929332e-07 -0.09929060352480942 -1.8557000000000001 0.7058525029187033 0.7058514967286655 -2.0216954494875483e-07 -0.09929081826208386 -1.8558000000000001 0.7058528814137643 0.7058518785645485 -1.9925715855767523e-07 -0.0992910329345877 -1.8559 0.7058532598256169 0.7058522602538934 -1.963097173637851e-07 -0.0992912475423403 -1.856 0.705853638154663 0.7058526417963673 -1.9332790954576518e-07 -0.09929146208536103 -1.8561 0.705854016401297 0.7058530231916447 -1.9031243099834616e-07 -0.09929167656366931 -1.8562 0.705854394565906 0.705853404439408 -1.8726398515189757e-07 -0.09929189097728458 -1.8563000000000003 0.7058547726488695 0.7058537855393465 -1.8418328280589424e-07 -0.09929210532622612 -1.8564 0.7058551506505588 0.7058541664911577 -1.8107104195891344e-07 -0.09929231961051335 -1.8565 0.7058555285713379 0.7058545472945468 -1.779279876733264e-07 -0.09929253383016559 -1.8566 0.7058559064115626 0.705854927949227 -1.7475485184978434e-07 -0.09929274798520227 -1.8567 0.705856284171581 0.7058553084549188 -1.7155237311272664e-07 -0.09929296207564267 -1.8568000000000002 0.7058566618517328 0.7058556888113513 -1.6832129660741824e-07 -0.09929317610150616 -1.8569 0.70585703945235 0.7058560690182615 -1.650623738299467e-07 -0.09929339006281207 -1.857 0.7058574169737563 0.7058564490753945 -1.6177636246415827e-07 -0.0992936039595797 -1.8571000000000002 0.7058577944162673 0.7058568289825037 -1.5846402618389932e-07 -0.09929381779182844 -1.8572 0.7058581717801902 0.7058572087393504 -1.551261345125038e-07 -0.0992940315595776 -1.8573000000000002 0.7058585490658242 0.7058575883457048 -1.5176346259901385e-07 -0.09929424526284653 -1.8574000000000002 0.7058589262734598 0.7058579678013449 -1.4837679107246315e-07 -0.09929445890165448 -1.8575 0.7058593034033787 0.7058583471060575 -1.4496690584585303e-07 -0.09929467247602078 -1.8576000000000001 0.7058596804558546 0.7058587262596375 -1.4153459794788437e-07 -0.0992948859859647 -1.8577000000000001 0.7058600574311527 0.7058591052618887 -1.3808066330611712e-07 -0.09929509943150555 -1.8578000000000001 0.7058604343295292 0.7058594841126234 -1.3460590260992722e-07 -0.09929531281266264 -1.8579 0.7058608111512321 0.7058598628116624 -1.3111112108325773e-07 -0.09929552612945526 -1.858 0.7058611878965007 0.7058602413588353 -1.275971283215549e-07 -0.09929573938190266 -1.8581 0.7058615645655648 0.7058606197539805 -1.240647380905402e-07 -0.0992959525700241 -1.8582 0.7058619411586462 0.7058609979969448 -1.2051476815620743e-07 -0.09929616569383887 -1.8583000000000003 0.7058623176759575 0.7058613760875843 -1.1694804007839066e-07 -0.09929637875336621 -1.8584 0.7058626941177026 0.7058617540257635 -1.1336537902688348e-07 -0.09929659174862537 -1.8585 0.7058630704840767 0.705862131811356 -1.0976761359408893e-07 -0.09929680467963563 -1.8586 0.7058634467752657 0.7058625094442448 -1.0615557559379152e-07 -0.09929701754641626 -1.8587 0.7058638229914465 0.7058628869243205 -1.0253009988074602e-07 -0.0992972303489864 -1.8588000000000002 0.7058641991327872 0.705863264251484 -9.889202414858217e-08 -0.09929744308736532 -1.8589 0.705864575199447 0.705863641425645 -9.524218874071982e-08 -0.0992976557615723 -1.859 0.7058649511915756 0.7058640184467214 -9.158143645261047e-08 -0.09929786837162653 -1.8591000000000002 0.705865327109314 0.7058643953146411 -8.791061234265235e-08 -0.0992980809175472 -1.8592 0.7058657029527942 0.7058647720293403 -8.423056353876884e-08 -0.09929829339935349 -1.8593000000000002 0.7058660787221382 0.7058651485907652 -8.054213903371105e-08 -0.09929850581706468 -1.8594000000000002 0.7058664544174607 0.7058655249988703 -7.684618949597294e-08 -0.0992987181706999 -1.8595 0.7058668300388651 0.7058659012536197 -7.314356706899713e-08 -0.09929893046027843 -1.8596000000000001 0.7058672055864471 0.7058662773549864 -6.943512518209002e-08 -0.0992991426858194 -1.8597000000000001 0.7058675810602926 0.7058666533029525 -6.572171834832649e-08 -0.09929935484734193 -1.8598000000000001 0.7058679564604784 0.7058670290975098 -6.20042019676588e-08 -0.0992995669448653 -1.8599 0.7058683317870722 0.7058674047386584 -5.8283432133928587e-08 -0.09929977897840858 -1.86 0.7058687070401328 0.7058677802264084 -5.45602654310369e-08 -0.09929999094799105 -1.8601 0.7058690822197091 0.7058681555607784 -5.08355587434256e-08 -0.09930020285363177 -1.8602 0.7058694573258415 0.7058685307417969 -4.711016905463265e-08 -0.09930041469534995 -1.8603000000000003 0.7058698323585604 0.7058689057695009 -4.3384953249370976e-08 -0.09930062647316469 -1.8604 0.705870207317888 0.7058692806439372 -3.966076792032364e-08 -0.09930083818709518 -1.8605 0.7058705822038365 0.7058696553651612 -3.593846916859645e-08 -0.09930104983716051 -1.8606 0.705870957016409 0.7058700299332379 -3.221891240498369e-08 -0.09930126142337986 -1.8607 0.7058713317556002 0.7058704043482409 -2.8502952158226957e-08 -0.0993014729457723 -1.8608000000000002 0.7058717064213946 0.7058707786102536 -2.4791441876389347e-08 -0.09930168440435698 -1.8609 0.7058720810137683 0.7058711527193682 -2.108523373131957e-08 -0.099301895799153 -1.861 0.7058724555326878 0.7058715266756861 -1.738517842056822e-08 -0.09930210713017948 -1.8611000000000002 0.7058728299781107 0.7058719004793175 -1.369212497591768e-08 -0.0993023183974555 -1.8612 0.7058732043499856 0.705872274130382 -1.0006920566490995e-08 -0.09930252960100017 -1.8613000000000002 0.7058735786482518 0.705872647629008 -6.330410306197576e-09 -0.09930274074083256 -1.8614000000000002 0.7058739528728397 0.7058730209753333 -2.6634370568420773e-09 -0.09930295181697174 -1.8615 0.7058743270236709 0.7058733941695046 9.931587574910083e-10 -0.0993031628294369 -1.8616000000000001 0.7058747011006574 0.7058737672116773 4.638539359905214e-09 -0.09930337377824695 -1.8617000000000001 0.7058750751037026 0.7058741401020155 8.271869788092912e-09 -0.09930358466342105 -1.8618000000000001 0.7058754490327013 0.705874512840693 1.189231810683894e-08 -0.09930379548497827 -1.8619 0.705875822887539 0.705874885427892 1.5499055585829757e-08 -0.09930400624293764 -1.862 0.7058761966680925 0.7058752578638039 1.909125690088137e-08 -0.09930421693731827 -1.8621 0.7058765703742294 0.705875630148628 2.266810031001376e-08 -0.09930442756813906 -1.8622 0.7058769440058088 0.7058760022825732 2.6228767841668388e-08 -0.09930463813541918 -1.8623000000000003 0.7058773175626814 0.7058763742658571 2.977244549333402e-08 -0.09930484863917761 -1.8624 0.7058776910446887 0.7058767460987057 3.329832341802952e-08 -0.09930505907943342 -1.8625 0.705878064451664 0.7058771177813535 3.680559608823519e-08 -0.09930526945620562 -1.8626 0.7058784377834315 0.7058774893140438 4.029346250405963e-08 -0.09930547976951315 -1.8627 0.7058788110398072 0.7058778606970281 4.376112635630369e-08 -0.09930569001937511 -1.8628000000000002 0.7058791842205987 0.705878231930567 4.720779622942317e-08 -0.09930590020581048 -1.8629 0.705879557325605 0.7058786030149291 5.063268576632751e-08 -0.09930611032883828 -1.863 0.7058799303546166 0.7058789739503912 5.403501384532161e-08 -0.09930632038847748 -1.8631000000000002 0.7058803033074158 0.7058793447372389 5.741400477266012e-08 -0.09930653038474706 -1.8632 0.7058806761837766 0.7058797153757653 6.076888845081563e-08 -0.099306740317666 -1.8633000000000002 0.7058810489834648 0.7058800858662726 6.40989005450121e-08 -0.09930695018725329 -1.8634000000000002 0.7058814217062386 0.7058804562090704 6.740328268965701e-08 -0.09930715999352793 -1.8635 0.7058817943518472 0.7058808264044765 7.06812826167108e-08 -0.09930736973650885 -1.8636000000000001 0.7058821669200321 0.7058811964528169 7.393215435864964e-08 -0.09930757941621504 -1.8637000000000001 0.7058825394105274 0.7058815663544253 7.715515840112097e-08 -0.0993077890326654 -1.8638000000000001 0.7058829118230586 0.7058819361096434 8.034956185641595e-08 -0.09930799858587894 -1.8639000000000001 0.7058832841573441 0.7058823057188206 8.351463864561537e-08 -0.09930820807587458 -1.864 0.7058836564130939 0.7058826751823137 8.664966963389809e-08 -0.0993084175026712 -1.8641 0.7058840285900112 0.705883044500488 8.975394282309535e-08 -0.09930862686628787 -1.8642 0.7058844006877907 0.705883413673715 9.282675348526448e-08 -0.09930883616674337 -1.8643000000000003 0.7058847727061204 0.705883782702375 9.586740434830432e-08 -0.09930904540405676 -1.8644 0.7058851446446803 0.7058841515868544 9.887520573820252e-08 -0.09930925457824683 -1.8645 0.7058855165031436 0.7058845203275481 1.0184947573863012e-07 -0.09930946368933255 -1.8646 0.705885888281176 0.7058848889248575 1.0478954035053611e-07 -0.09930967273733285 -1.8647 0.7058862599784361 0.7058852573791912 1.0769473364827253e-07 -0.09930988172226657 -1.8648000000000002 0.7058866315945753 0.7058856256909648 1.1056439790102512e-07 -0.0993100906441526 -1.8649 0.7058870031292387 0.7058859938606012 1.1339788375322457e-07 -0.0993102995030099 -1.865 0.7058873745820634 0.7058863618885298 1.1619455038414106e-07 -0.09931050829885729 -1.8651000000000002 0.7058877459526809 0.7058867297751868 1.1895376560155935e-07 -0.09931071703171372 -1.8652 0.7058881172407152 0.7058870975210152 1.216749060152511e-07 -0.09931092570159798 -1.8653000000000002 0.7058884884457837 0.7058874651264644 1.243573571896306e-07 -0.09931113430852893 -1.8654000000000002 0.7058888595674983 0.7058878325919902 1.2700051377212418e-07 -0.09931134285252549 -1.8655 0.7058892306054634 0.7058881999180554 1.296037796215399e-07 -0.09931155133360652 -1.8656000000000001 0.7058896015592773 0.7058885671051282 1.321665679294981e-07 -0.09931175975179081 -1.8657000000000001 0.7058899724285327 0.7058889341536831 1.3468830139390375e-07 -0.09931196810709722 -1.8658000000000001 0.7058903432128156 0.7058893010642013 1.37168412316091e-07 -0.0993121763995446 -1.8659000000000001 0.7058907139117064 0.7058896678371697 1.3960634273960104e-07 -0.09931238462915175 -1.866 0.7058910845247797 0.7058900344730807 1.4200154456467384e-07 -0.09931259279593757 -1.8661 0.7058914550516038 0.7058904009724329 1.4435347970090384e-07 -0.09931280089992087 -1.8662 0.7058918254917419 0.70589076733573 1.4666162015050666e-07 -0.09931300894112038 -1.8663000000000003 0.7058921958447515 0.7058911335634817 1.489254481505664e-07 -0.09931321691955505 -1.8664 0.7058925661101844 0.7058914996562029 1.511444562736497e-07 -0.09931342483524357 -1.8665 0.7058929362875872 0.705891865614414 1.5331814757352236e-07 -0.09931363268820476 -1.8666 0.7058933063765014 0.7058922314386402 1.554460356475995e-07 -0.0993138404784574 -1.8667 0.7058936763764634 0.7058925971294122 1.575276447791929e-07 -0.09931404820602031 -1.8668000000000002 0.7058940462870046 0.7058929626872654 1.5956251003812483e-07 -0.09931425587091226 -1.8669 0.7058944161076515 0.70589332811274 1.6155017739521993e-07 -0.09931446347315198 -1.867 0.705894785837926 0.7058936934063815 1.634902037778163e-07 -0.09931467101275836 -1.8671000000000002 0.7058951554773452 0.7058940585687392 1.6538215722936012e-07 -0.09931487848975008 -1.8672 0.7058955250254215 0.7058944236003674 1.6722561697879446e-07 -0.09931508590414591 -1.8673000000000002 0.7058958944816636 0.7058947885018243 1.690201735064789e-07 -0.09931529325596462 -1.8674000000000002 0.7058962638455752 0.705895153273673 1.7076542866562017e-07 -0.09931550054522492 -1.8675 0.7058966331166563 0.7058955179164802 1.7246099580370267e-07 -0.09931570777194564 -1.8676000000000001 0.7058970022944024 0.7058958824308168 1.7410649975208026e-07 -0.09931591493614539 -1.8677000000000001 0.705897371378306 0.7058962468172576 1.75701577002918e-07 -0.09931612203784301 -1.8678000000000001 0.7058977403678548 0.7058966110763808 1.772458757716422e-07 -0.09931632907705716 -1.8679000000000001 0.7058981092625338 0.7058969752087688 1.787390560108182e-07 -0.09931653605380662 -1.868 0.7058984780618238 0.705897339215007 1.8018078954892824e-07 -0.09931674296811005 -1.8681 0.7058988467652023 0.7058977030956848 1.8157076016322993e-07 -0.0993169498199862 -1.8682 0.705899215372144 0.7058980668513937 1.8290866360404223e-07 -0.09931715660945377 -1.8683 0.70589958388212 0.7058984304827296 1.8419420767107342e-07 -0.09931736333653146 -1.8684 0.7058999522945988 0.7058987939902903 1.8542711234526e-07 -0.09931757000123795 -1.8685 0.7059003206090455 0.7058991573746773 1.8660710975407224e-07 -0.09931777660359194 -1.8686 0.705900688824923 0.7058995206364942 1.877339442651893e-07 -0.0993179831436121 -1.8687 0.7059010569416914 0.7058998837763474 1.8880737259058256e-07 -0.09931818962131712 -1.8688000000000002 0.705901424958808 0.7059002467948456 1.8982716376222952e-07 -0.09931839603672565 -1.8689 0.7059017928757285 0.7059006096926006 1.9079309923619725e-07 -0.0993186023898564 -1.869 0.7059021606919058 0.705900972470225 1.9170497290305066e-07 -0.09931880868072797 -1.8691000000000002 0.7059025284067909 0.7059013351283345 1.9256259116071095e-07 -0.09931901490935903 -1.8692 0.705902896019833 0.7059016976675465 1.933657729248639e-07 -0.09931922107576827 -1.8693000000000002 0.7059032635304794 0.70590206008848 1.9411434970528774e-07 -0.09931942717997434 -1.8694000000000002 0.7059036309381755 0.7059024223917558 1.9480816561279202e-07 -0.09931963322199583 -1.8695 0.7059039982423657 0.705902784577996 1.954470773800343e-07 -0.09931983920185145 -1.8696000000000002 0.7059043654424925 0.7059031466478243 1.9603095443784802e-07 -0.09932004511955969 -1.8697000000000001 0.705904732537997 0.7059035086018653 1.9655967889789516e-07 -0.09932025097513925 -1.8698000000000001 0.7059050995283203 0.7059038704407454 1.9703314558736085e-07 -0.09932045676860876 -1.8699000000000001 0.7059054664129012 0.7059042321650911 1.9745126208017827e-07 -0.0993206624999868 -1.87 0.7059058331911785 0.7059045937755302 1.9781394870743707e-07 -0.099320868169292 -1.8701 0.7059061998625898 0.705904955272691 1.9812113855738334e-07 -0.09932107377654295 -1.8702 0.7059065664265725 0.7059053166572029 1.983727775274613e-07 -0.09932127932175826 -1.8703 0.7059069328825631 0.705905677929695 1.9856882428961886e-07 -0.09932148480495648 -1.8704 0.7059072992299985 0.705906039090797 1.9870925033194098e-07 -0.09932169022615622 -1.8705 0.7059076654683147 0.7059064001411388 1.9879403988579125e-07 -0.0993218955853761 -1.8706 0.7059080315969484 0.7059067610813501 1.9882319006112037e-07 -0.09932210088263464 -1.8707 0.7059083976153355 0.7059071219120603 1.9879671071462712e-07 -0.0993223061179504 -1.8708000000000002 0.7059087635229131 0.7059074826338991 1.987146245018001e-07 -0.09932251129134197 -1.8709 0.7059091293191182 0.7059078432474954 1.9857696687691773e-07 -0.09932271640282786 -1.871 0.7059094950033884 0.7059082037534778 1.9838378605488427e-07 -0.0993229214524267 -1.8711000000000002 0.7059098605751619 0.7059085641524738 1.9813514298347434e-07 -0.09932312644015699 -1.8712 0.7059102260338779 0.7059089244451106 1.9783111139884402e-07 -0.0993233313660373 -1.8713000000000002 0.7059105913789765 0.7059092846320136 1.9747177770063074e-07 -0.0993235362300861 -1.8714000000000002 0.7059109566098984 0.7059096447138083 1.9705724100399502e-07 -0.09932374103232199 -1.8715 0.7059113217260864 0.7059100046911181 1.965876130979871e-07 -0.09932394577276343 -1.8716000000000002 0.7059116867269837 0.705910364564565 1.9606301838309692e-07 -0.09932415045142896 -1.8717000000000001 0.7059120516120356 0.7059107243347704 1.954835938920707e-07 -0.09932435506833714 -1.8718000000000001 0.7059124163806887 0.705911084002353 1.9484948923093048e-07 -0.09932455962350639 -1.8719000000000001 0.7059127810323915 0.7059114435679306 1.9416086650611564e-07 -0.09932476411695527 -1.872 0.7059131455665945 0.7059118030321181 1.934179003314218e-07 -0.09932496854870226 -1.8721 0.7059135099827498 0.7059121623955293 1.9262077777248976e-07 -0.09932517291876584 -1.8722 0.7059138742803122 0.7059125216587754 1.9176969830170254e-07 -0.0993253772271645 -1.8723 0.7059142384587384 0.7059128808224655 1.908648737079799e-07 -0.09932558147391672 -1.8724 0.7059146025174876 0.7059132398872059 1.899065281037171e-07 -0.09932578565904099 -1.8725 0.7059149664560217 0.7059135988536007 1.8889489783804891e-07 -0.09932598978255577 -1.8726 0.7059153302738052 0.7059139577222513 1.8783023144827715e-07 -0.09932619384447955 -1.8727 0.7059156939703048 0.7059143164937562 1.867127896078291e-07 -0.09932639784483072 -1.8728000000000002 0.705916057544991 0.7059146751687109 1.8554284501176577e-07 -0.09932660178362779 -1.8729 0.7059164209973373 0.7059150337477074 1.8432068239759847e-07 -0.09932680566088917 -1.873 0.7059167843268198 0.7059153922313355 1.8304659838569437e-07 -0.09932700947663334 -1.8731000000000002 0.7059171475329185 0.7059157506201807 1.817209014688681e-07 -0.0993272132308787 -1.8732 0.7059175106151162 0.7059161089148256 1.803439119117678e-07 -0.0993274169236437 -1.8733000000000002 0.7059178735729 0.7059164671158491 1.789159616918945e-07 -0.09932762055494676 -1.8734000000000002 0.7059182364057603 0.7059168252238261 1.7743739440939654e-07 -0.09932782412480633 -1.8735 0.7059185991131911 0.7059171832393281 1.759085651725778e-07 -0.09932802763324076 -1.8736000000000002 0.705918961694691 0.7059175411629223 1.743298405978977e-07 -0.0993282310802685 -1.8737000000000001 0.7059193241497621 0.7059178989951718 1.7270159862955992e-07 -0.09932843446590797 -1.8738000000000001 0.7059196864779106 0.7059182567366359 1.7102422848400134e-07 -0.0993286377901775 -1.8739000000000001 0.7059200486786475 0.7059186143878693 1.6929813059091137e-07 -0.09932884105309558 -1.874 0.705920410751488 0.7059189719494221 1.6752371644404573e-07 -0.09932904425468052 -1.8741 0.7059207726959518 0.7059193294218398 1.6570140853530702e-07 -0.09932924739495065 -1.8742 0.7059211345115631 0.7059196868056643 1.6383164024025287e-07 -0.09932945047392451 -1.8743 0.7059214961978513 0.7059200441014312 1.6191485574176823e-07 -0.09932965349162037 -1.8744 0.70592185775435 0.7059204013096717 1.599515098704707e-07 -0.09932985644805657 -1.8745 0.7059222191805989 0.7059207584309126 1.5794206806654665e-07 -0.09933005934325154 -1.8746 0.7059225804761415 0.7059211154656748 1.558870061958706e-07 -0.09933026217722359 -1.8747 0.7059229416405275 0.7059214724144743 1.5378681051878007e-07 -0.09933046494999107 -1.8748000000000002 0.7059233026733114 0.705921829277822 1.5164197748884778e-07 -0.09933066766157234 -1.8749 0.7059236635740535 0.7059221860562226 1.4945301370083985e-07 -0.09933087031198574 -1.875 0.7059240243423193 0.7059225427501761 1.4722043575540744e-07 -0.09933107290124961 -1.8751000000000002 0.7059243849776802 0.705922899360176 1.4494477010643103e-07 -0.09933127542938223 -1.8752 0.7059247454797131 0.7059232558867108 1.4262655298816207e-07 -0.09933147789640193 -1.8753000000000002 0.7059251058480012 0.7059236123302628 1.4026633023828117e-07 -0.09933168030232709 -1.8754000000000002 0.7059254660821332 0.7059239686913079 1.3786465722157026e-07 -0.09933188264717596 -1.8755 0.7059258261817043 0.7059243249703167 1.354220986425625e-07 -0.0993320849309669 -1.8756000000000002 0.7059261861463155 0.7059246811677531 1.329392284657449e-07 -0.09933228715371818 -1.8757000000000001 0.7059265459755741 0.7059250372840744 1.3041662973514723e-07 -0.09933248931544807 -1.8758000000000001 0.7059269056690938 0.7059253933197327 1.27854894466789e-07 -0.09933269141617485 -1.8759000000000001 0.7059272652264947 0.7059257492751723 1.2525462349949334e-07 -0.09933289345591682 -1.876 0.7059276246474038 0.7059261051508317 1.2261642637692582e-07 -0.09933309543469228 -1.8761 0.7059279839314544 0.7059264609471427 1.199409211567748e-07 -0.0993332973525195 -1.8762 0.7059283430782864 0.7059268166645305 1.1722873431360692e-07 -0.09933349920941675 -1.8763 0.7059287020875469 0.7059271723034126 1.1448050054804759e-07 -0.09933370100540227 -1.8764 0.7059290609588895 0.7059275278642008 1.1169686268963641e-07 -0.09933390274049436 -1.8765 0.7059294196919752 0.7059278833472988 1.0887847149906871e-07 -0.0993341044147112 -1.8766 0.7059297782864716 0.7059282387531041 1.0602598557105103e-07 -0.09933430602807113 -1.8767 0.7059301367420538 0.7059285940820061 1.031400710949093e-07 -0.09933450758059227 -1.8768000000000002 0.705930495058404 0.7059289493343881 1.0022140181295547e-07 -0.09933470907229296 -1.8769 0.7059308532352114 0.7059293045106254 9.727065872211504e-08 -0.09933491050319138 -1.877 0.7059312112721734 0.7059296596110858 9.428853006351878e-08 -0.09933511187330576 -1.8771000000000002 0.705931569168994 0.7059300146361298 9.12757110657636e-08 -0.09933531318265436 -1.8772 0.7059319269253854 0.7059303695861104 8.823290380613469e-08 -0.09933551443125535 -1.8773000000000002 0.705932284541067 0.7059307244613728 8.516081704407208e-08 -0.09933571561912696 -1.8774000000000002 0.7059326420157659 0.7059310792622548 8.206016609280109e-08 -0.09933591674628739 -1.8775 0.7059329993492167 0.7059314339890862 7.893167258687939e-08 -0.0993361178127548 -1.8776000000000002 0.7059333565411627 0.7059317886421888 7.577606438505247e-08 -0.09933631881854742 -1.8777000000000001 0.7059337135913539 0.7059321432218771 7.25940753221882e-08 -0.0993365197636834 -1.8778000000000001 0.7059340704995494 0.7059324977284571 6.938644512947956e-08 -0.09933672064818098 -1.8779000000000001 0.705934427265515 0.7059328521622272 6.615391918811386e-08 -0.0993369214720583 -1.878 0.7059347838890256 0.7059332065234776 6.289724839049493e-08 -0.09933712223533354 -1.8781 0.7059351403698642 0.70593356081249 5.961718895983181e-08 -0.0993373229380249 -1.8782 0.7059354967078213 0.7059339150295381 5.631450227840118e-08 -0.09933752358015047 -1.8783 0.705935852902696 0.7059342691748877 5.298995469325829e-08 -0.09933772416172844 -1.8784 0.7059362089542955 0.7059346232487962 4.964431736705077e-08 -0.09933792468277697 -1.8785 0.7059365648624356 0.7059349772515124 4.627836606811708e-08 -0.0993381251433142 -1.8786 0.7059369206269401 0.7059353311832767 4.2892881019565565e-08 -0.09933832554335821 -1.8787 0.7059372762476418 0.7059356850443215 3.9488646703250696e-08 -0.09933852588292724 -1.8788000000000002 0.7059376317243813 0.7059360388348701 3.606645168630074e-08 -0.09933872616203931 -1.8789 0.7059379870570077 0.705936392555138 3.262708841815509e-08 -0.09933892638071261 -1.879 0.7059383422453795 0.7059367462053316 2.9171353058826677e-08 -0.09933912653896526 -1.8791000000000002 0.7059386972893626 0.7059370997856489 2.570004531757264e-08 -0.09933932663681529 -1.8792 0.7059390521888325 0.7059374532962792 2.221396823258448e-08 -0.09933952667428088 -1.8793000000000002 0.7059394069436726 0.7059378067374036 1.871392800792404e-08 -0.09933972665138016 -1.8794000000000002 0.7059397615537757 0.7059381601091936 1.520073381403031e-08 -0.09933992656813118 -1.8795 0.7059401160190426 0.705938513411813 1.1675197613379706e-08 -0.09934012642455203 -1.8796000000000002 0.705940470339383 0.7059388666454156 8.138133954053994e-09 -0.09934032622066076 -1.8797000000000001 0.7059408245147158 0.7059392198101477 4.590359807543631e-09 -0.0993405259564755 -1.8798000000000001 0.7059411785449682 0.7059395729061464 1.0326943536420607e-09 -0.09934072563201433 -1.8799000000000001 0.7059415324300765 0.7059399259335395 -2.5340411843530197e-09 -0.0993409252472953 -1.88 0.7059418861699854 0.7059402788924463 -6.10902375040856e-09 -0.09934112480233646 -1.8801 0.705942239764649 0.7059406317829774 -9.691428635300037e-09 -0.09934132429715586 -1.8802 0.7059425932140301 0.7059409846052345 -1.3280429660058463e-08 -0.09934152373177164 -1.8803 0.7059429465181 0.7059413373593099 -1.6875199384137202e-08 -0.09934172310620178 -1.8804 0.7059432996768391 0.7059416900452876 -2.0474909277583275e-08 -0.0993419224204643 -1.8805 0.7059436526902367 0.7059420426632426 -2.4078729927035775e-08 -0.09934212167457725 -1.8806 0.7059440055582912 0.7059423952132404 -2.7685831213535017e-08 -0.09934232086855867 -1.8807 0.7059443582810094 0.7059427476953386 -3.1295382517003076e-08 -0.09934252000242656 -1.8808000000000002 0.7059447108584076 0.7059431001095853 -3.490655289752238e-08 -0.09934271907619902 -1.8809 0.7059450632905108 0.7059434524560193 -3.851851128583005e-08 -0.09934291808989398 -1.881 0.7059454155773526 0.7059438047346711 -4.213042668541316e-08 -0.0993431170435295 -1.8811000000000002 0.705945767718976 0.705944156945562 -4.574146835260829e-08 -0.0993433159371236 -1.8812 0.7059461197154321 0.7059445090887045 -4.935080599103962e-08 -0.09934351477069422 -1.8813000000000002 0.7059464715667818 0.7059448611641024 -5.295760994528456e-08 -0.0993437135442594 -1.8814000000000002 0.7059468232730945 0.7059452131717499 -5.656105138743782e-08 -0.09934391225783713 -1.8815 0.7059471748344484 0.7059455651116328 -6.016030250940822e-08 -0.09934411091144535 -1.8816000000000002 0.7059475262509305 0.7059459169837282 -6.375453671632683e-08 -0.09934430950510209 -1.8817000000000002 0.7059478775226367 0.7059462687880041 -6.734292880587398e-08 -0.09934450803882532 -1.8818000000000001 0.7059482286496719 0.7059466205244195 -7.092465517102506e-08 -0.09934470651263294 -1.8819000000000001 0.7059485796321496 0.7059469721929248 -7.449889398176285e-08 -0.09934490492654295 -1.882 0.705948930470192 0.7059473237934616 -7.806482537047604e-08 -0.09934510328057329 -1.8821 0.7059492811639307 0.7059476753259628 -8.162163162971775e-08 -0.09934530157474199 -1.8822 0.7059496317135053 0.7059480267903524 -8.516849738827992e-08 -0.09934549980906694 -1.8823 0.7059499821190642 0.7059483781865455 -8.870460980765077e-08 -0.0993456979835661 -1.8824 0.7059503323807645 0.7059487295144489 -9.222915876242604e-08 -0.09934589609825734 -1.8825 0.7059506824987722 0.7059490807739606 -9.57413370285265e-08 -0.09934609415315865 -1.8826 0.7059510324732621 0.7059494319649697 -9.924034046621122e-08 -0.09934629214828798 -1.8827 0.7059513823044169 0.7059497830873573 -1.0272536820569306e-07 -0.09934649008366321 -1.8828000000000003 0.7059517319924282 0.705950134140995 -1.0619562283015194e-07 -0.09934668795930222 -1.8829 0.7059520815374962 0.7059504851257468 -1.0965031055788083e-07 -0.09934688577522298 -1.883 0.7059524309398295 0.7059508360414677 -1.1308864142182962e-07 -0.09934708353144335 -1.8831000000000002 0.7059527801996448 0.7059511868880046 -1.1650982945435318e-07 -0.09934728122798125 -1.8832 0.7059531293171677 0.7059515376651959 -1.1991309286675522e-07 -0.09934747886485458 -1.8833000000000002 0.7059534782926316 0.7059518883728717 -1.232976542132197e-07 -0.09934767644208124 -1.8834000000000002 0.7059538271262787 0.7059522390108535 -1.2666274060157967e-07 -0.09934787395967909 -1.8835 0.705954175818359 0.7059525895789548 -1.3000758382689104e-07 -0.09934807141766602 -1.8836000000000002 0.7059545243691308 0.7059529400769808 -1.3333142057959935e-07 -0.09934826881605988 -1.8837000000000002 0.7059548727788605 0.705953290504729 -1.366334926086038e-07 -0.09934846615487855 -1.8838000000000001 0.7059552210478226 0.7059536408619882 -1.3991304689299489e-07 -0.09934866343413991 -1.8839000000000001 0.7059555691763 0.7059539911485393 -1.4316933582073088e-07 -0.09934886065386178 -1.884 0.7059559171645826 0.7059543413641557 -1.4640161734996715e-07 -0.09934905781406206 -1.8841 0.7059562650129687 0.7059546915086023 -1.4960915517038542e-07 -0.09934925491475852 -1.8842 0.7059566127217649 0.705955041581637 -1.527912188957481e-07 -0.09934945195596909 -1.8843 0.7059569602912845 0.705955391583009 -1.5594708421134973e-07 -0.09934964893771153 -1.8844 0.7059573077218494 0.7059557415124602 -1.5907603303361162e-07 -0.09934984586000367 -1.8845 0.7059576550137889 0.7059560913697249 -1.6217735372171804e-07 -0.09935004272286346 -1.8846 0.7059580021674395 0.7059564411545298 -1.6525034114873993e-07 -0.09935023952630857 -1.8847 0.7059583491831454 0.7059567908665941 -1.6829429694623088e-07 -0.09935043627035685 -1.8848000000000003 0.7059586960612582 0.70595714050563 -1.7130852962045362e-07 -0.09935063295502619 -1.8849 0.7059590428021367 0.7059574900713415 -1.7429235473452598e-07 -0.09935082958033434 -1.885 0.7059593894061473 0.7059578395634256 -1.772450950350557e-07 -0.09935102614629904 -1.8851000000000002 0.7059597358736633 0.7059581889815725 -1.8016608062040862e-07 -0.09935122265293816 -1.8852 0.7059600822050649 0.7059585383254654 -1.8305464908816016e-07 -0.09935141910026946 -1.8853000000000002 0.7059604284007392 0.70595888759478 -1.8591014571203712e-07 -0.0993516154883107 -1.8854000000000002 0.7059607744610811 0.7059592367891852 -1.8873192353385804e-07 -0.0993518118170797 -1.8855 0.7059611203864915 0.7059595859083432 -1.9151934357169997e-07 -0.0993520080865942 -1.8856000000000002 0.7059614661773785 0.705959934951909 -1.942717749343903e-07 -0.09935220429687201 -1.8857000000000002 0.7059618118341564 0.7059602839195318 -1.9698859493946785e-07 -0.09935240044793087 -1.8858000000000001 0.7059621573572463 0.7059606328108532 -1.9966918931094146e-07 -0.0993525965397885 -1.8859000000000001 0.7059625027470758 0.7059609816255091 -2.0231295227643442e-07 -0.0993527925724627 -1.886 0.7059628480040792 0.7059613303631285 -2.0491928670596238e-07 -0.09935298854597116 -1.8861 0.7059631931286964 0.7059616790233343 -2.0748760427499735e-07 -0.0993531844603317 -1.8862 0.7059635381213738 0.7059620276057432 -2.1001732555814279e-07 -0.09935338031556197 -1.8863 0.7059638829825642 0.7059623761099658 -2.1250788021995315e-07 -0.09935357611167978 -1.8864 0.705964227712726 0.7059627245356067 -2.1495870704615894e-07 -0.09935377184870281 -1.8865 0.7059645723123237 0.7059630728822641 -2.1736925416224184e-07 -0.09935396752664877 -1.8866 0.7059649167818276 0.7059634211495314 -2.1973897912364038e-07 -0.09935416314553538 -1.8867 0.7059652611217134 0.7059637693369953 -2.2206734902677217e-07 -0.09935435870538041 -1.8868000000000003 0.7059656053324628 0.7059641174442374 -2.243538406374035e-07 -0.09935455420620147 -1.8869 0.7059659494145627 0.7059644654708337 -2.2659794051901883e-07 -0.09935474964801633 -1.887 0.7059662933685055 0.7059648134163548 -2.2879914513690425e-07 -0.09935494503084263 -1.8871000000000002 0.7059666371947887 0.705965161280366 -2.3095696096570029e-07 -0.09935514035469808 -1.8872 0.7059669808939153 0.7059655090624273 -2.3307090460389368e-07 -0.09935533561960036 -1.8873000000000002 0.7059673244663929 0.7059658567620939 -2.351405029091258e-07 -0.09935553082556713 -1.8874000000000002 0.7059676679127346 0.705966204378916 -2.3716529305370382e-07 -0.09935572597261612 -1.8875 0.7059680112334576 0.7059665519124387 -2.3914482266337855e-07 -0.09935592106076496 -1.8876000000000002 0.7059683544290848 0.7059668993622028 -2.4107864992489736e-07 -0.0993561160900313 -1.8877000000000002 0.7059686975001426 0.7059672467277438 -2.4296634364151526e-07 -0.0993563110604328 -1.8878000000000001 0.7059690404471626 0.7059675940085932 -2.4480748336483393e-07 -0.09935650597198714 -1.8879000000000001 0.7059693832706808 0.7059679412042785 -2.4660165949194623e-07 -0.09935670082471199 -1.888 0.7059697259712369 0.7059682883143217 -2.483484733487029e-07 -0.09935689561862489 -1.8881000000000001 0.7059700685493749 0.705968635338242 -2.500475372244071e-07 -0.09935709035374353 -1.8882 0.7059704110056435 0.7059689822755537 -2.516984745903894e-07 -0.09935728503008562 -1.8883 0.7059707533405943 0.7059693291257676 -2.5330092002714966e-07 -0.09935747964766865 -1.8884 0.7059710955547833 0.7059696758883904 -2.5485451941517634e-07 -0.09935767420651027 -1.8885 0.70597143764877 0.7059700225629254 -2.5635892995576337e-07 -0.09935786870662816 -1.8886 0.7059717796231175 0.7059703691488722 -2.5781382028203237e-07 -0.09935806314803991 -1.8887 0.7059721214783921 0.7059707156457271 -2.592188705283216e-07 -0.0993582575307631 -1.8888000000000003 0.7059724632151636 0.7059710620529833 -2.605737723475332e-07 -0.0993584518548154 -1.8889 0.7059728048340046 0.7059714083701298 -2.6187822904644165e-07 -0.09935864612021425 -1.889 0.7059731463354911 0.7059717545966542 -2.6313195564120484e-07 -0.09935884032697741 -1.8891000000000002 0.7059734877202019 0.7059721007320395 -2.6433467886430306e-07 -0.0993590344751223 -1.8892 0.7059738289887184 0.7059724467757672 -2.654861372790307e-07 -0.09935922856466661 -1.8893000000000002 0.7059741701416251 0.7059727927273155 -2.665860813350074e-07 -0.09935942259562788 -1.8894000000000002 0.7059745111795086 0.7059731385861603 -2.676342733820558e-07 -0.09935961656802372 -1.8895 0.7059748521029579 0.7059734843517749 -2.6863048773959064e-07 -0.09935981048187165 -1.8896000000000002 0.7059751929125646 0.7059738300236301 -2.69574510762538e-07 -0.09936000433718921 -1.8897 0.705975533608922 0.7059741756011955 -2.7046614089684673e-07 -0.09936019813399401 -1.8898000000000001 0.7059758741926256 0.7059745210839374 -2.713051886690798e-07 -0.09936039187230356 -1.8899000000000001 0.705976214664273 0.7059748664713212 -2.7209147675927303e-07 -0.0993605855521354 -1.89 0.7059765550244634 0.70597521176281 -2.728248400564459e-07 -0.09936077917350708 -1.8901000000000001 0.7059768952737975 0.7059755569578653 -2.7350512565166296e-07 -0.09936097273643614 -1.8902 0.7059772354128772 0.7059759020559476 -2.7413219290048363e-07 -0.0993611662409401 -1.8903 0.7059775754423063 0.7059762470565152 -2.747059134472485e-07 -0.09936135968703644 -1.8904 0.7059779153626895 0.7059765919590262 -2.752261712250792e-07 -0.0993615530747427 -1.8905 0.7059782551746328 0.7059769367629367 -2.7569286252179803e-07 -0.09936174640407643 -1.8906 0.7059785948787429 0.7059772814677021 -2.761058959764584e-07 -0.09936193967505512 -1.8907 0.7059789344756278 0.705977626072777 -2.7646519260016156e-07 -0.0993621328876962 -1.8908000000000003 0.7059792739658954 0.7059779705776158 -2.7677068575177044e-07 -0.09936232604201728 -1.8909 0.7059796133501549 0.7059783149816713 -2.7702232122464587e-07 -0.09936251913803579 -1.891 0.7059799526290154 0.7059786592843966 -2.772200572258299e-07 -0.0993627121757692 -1.8911000000000002 0.7059802918030866 0.7059790034852444 -2.773638643413512e-07 -0.09936290515523503 -1.8912 0.7059806308729781 0.7059793475836669 -2.774537255743892e-07 -0.09936309807645069 -1.8913000000000002 0.7059809698393 0.7059796915791168 -2.7748963636262114e-07 -0.09936329093943375 -1.8914000000000002 0.7059813087026616 0.7059800354710462 -2.7747160454005826e-07 -0.09936348374420156 -1.8915 0.7059816474636726 0.7059803792589083 -2.7739965036133185e-07 -0.09936367649077171 -1.8916000000000002 0.7059819861229415 0.7059807229421559 -2.7727380645312105e-07 -0.09936386917916151 -1.8917 0.7059823246810774 0.7059810665202425 -2.77094117869664e-07 -0.09936406180938849 -1.8918000000000001 0.7059826631386878 0.7059814099926223 -2.7686064198173543e-07 -0.09936425438147008 -1.8919000000000001 0.7059830014963799 0.7059817533587506 -2.765734485876692e-07 -0.09936444689542373 -1.892 0.7059833397547601 0.705982096618083 -2.7623261974682456e-07 -0.09936463935126688 -1.8921000000000001 0.7059836779144335 0.7059824397700762 -2.7583824988713923e-07 -0.09936483174901695 -1.8922 0.7059840159760038 0.7059827828141885 -2.7539044567675974e-07 -0.09936502408869134 -1.8923 0.7059843539400739 0.7059831257498789 -2.7488932608996097e-07 -0.09936521637030746 -1.8924 0.705984691807245 0.7059834685766084 -2.7433502232734885e-07 -0.09936540859388279 -1.8925 0.7059850295781165 0.7059838112938394 -2.7372767773953255e-07 -0.09936560075943468 -1.8926 0.7059853672532868 0.7059841539010354 -2.730674478687578e-07 -0.09936579286698055 -1.8927 0.7059857048333515 0.7059844963976627 -2.7235450037257913e-07 -0.0993659849165378 -1.8928000000000003 0.7059860423189054 0.7059848387831882 -2.715890149961042e-07 -0.09936617690812374 -1.8929 0.7059863797105403 0.7059851810570825 -2.7077118349913554e-07 -0.09936636884175591 -1.893 0.7059867170088463 0.705985523218817 -2.6990120963882314e-07 -0.09936656071745159 -1.8931000000000002 0.7059870542144107 0.7059858652678663 -2.689793090863979e-07 -0.09936675253522821 -1.8932 0.7059873913278187 0.7059862072037071 -2.6800570940288537e-07 -0.09936694429510311 -1.8933000000000002 0.7059877283496527 0.7059865490258186 -2.6698064999400306e-07 -0.09936713599709365 -1.8934000000000002 0.7059880652804926 0.7059868907336829 -2.6590438201648525e-07 -0.09936732764121725 -1.8935 0.7059884021209151 0.7059872323267847 -2.647771683295108e-07 -0.09936751922749118 -1.8936000000000002 0.705988738871494 0.7059875738046119 -2.635992834218448e-07 -0.09936771075593277 -1.8937 0.7059890755328009 0.705987915166655 -2.623710133702051e-07 -0.09936790222655947 -1.8938000000000001 0.7059894121054027 0.7059882564124087 -2.610926557629345e-07 -0.09936809363938856 -1.8939000000000001 0.7059897485898639 0.7059885975413702 -2.5976451962714253e-07 -0.0993682849944374 -1.894 0.7059900849867455 0.70598893855304 -2.583869253142135e-07 -0.09936847629172334 -1.8941000000000001 0.7059904212966046 0.7059892794469228 -2.569602044998065e-07 -0.09936866753126364 -1.8942 0.705990757519995 0.7059896202225266 -2.5548470002426105e-07 -0.0993688587130757 -1.8943 0.705991093657466 0.7059899608793633 -2.539607658717802e-07 -0.09936904983717676 -1.8944 0.7059914297095633 0.7059903014169485 -2.5238876706634716e-07 -0.09936924090358412 -1.8945 0.705991765676829 0.7059906418348024 -2.5076907956764205e-07 -0.09936943191231512 -1.8946 0.7059921015598005 0.7059909821324493 -2.491020902051222e-07 -0.09936962286338716 -1.8947 0.705992437359011 0.7059913223094169 -2.4738819655312216e-07 -0.09936981375681737 -1.8948000000000003 0.7059927730749891 0.705991662365238 -2.4562780686493424e-07 -0.0993700045926231 -1.8949 0.7059931087082596 0.7059920022994498 -2.4382133996525557e-07 -0.09937019537082165 -1.895 0.705993444259342 0.7059923421115941 -2.4196922517732977e-07 -0.09937038609143029 -1.8951000000000002 0.705993779728751 0.7059926818012174 -2.400719021806996e-07 -0.09937057675446627 -1.8952 0.7059941151169973 0.7059930213678713 -2.3812982092447088e-07 -0.09937076735994695 -1.8953000000000002 0.7059944504245856 0.7059933608111117 -2.3614344150935107e-07 -0.09937095790788952 -1.8954000000000002 0.7059947856520159 0.7059937001305002 -2.3411323411132168e-07 -0.09937114839831122 -1.8955 0.7059951207997834 0.7059940393256032 -2.3203967882898247e-07 -0.09937133883122935 -1.8956000000000002 0.7059954558683776 0.7059943783959923 -2.2992326560722365e-07 -0.09937152920666112 -1.8957 0.7059957908582826 0.7059947173412449 -2.2776449409497856e-07 -0.0993717195246238 -1.8958000000000002 0.7059961257699775 0.7059950561609433 -2.2556387353420138e-07 -0.09937190978513465 -1.8959000000000001 0.7059964606039351 0.7059953948546759 -2.233219226523142e-07 -0.09937209998821085 -1.896 0.7059967953606228 0.7059957334220366 -2.2103916952342928e-07 -0.09937229013386967 -1.8961000000000001 0.7059971300405026 0.7059960718626246 -2.187161514365099e-07 -0.0993724802221283 -1.8962 0.7059974646440301 0.7059964101760454 -2.16353414798226e-07 -0.09937267025300395 -1.8963 0.7059977991716553 0.705996748361911 -2.1395151499764564e-07 -0.09937286022651391 -1.8964 0.7059981336238217 0.7059970864198382 -2.1151101624664048e-07 -0.09937305014267528 -1.8965 0.7059984680009671 0.7059974243494511 -2.090324915000885e-07 -0.09937324000150538 -1.8966 0.7059988023035229 0.7059977621503796 -2.06516522261585e-07 -0.09937342980302137 -1.8967 0.7059991365319136 0.7059980998222594 -2.0396369849323692e-07 -0.09937361954724036 -1.8968000000000003 0.7059994706865582 0.7059984373647334 -2.0137461843178217e-07 -0.09937380923417961 -1.8969 0.7059998047678686 0.7059987747774508 -1.9874988851226183e-07 -0.09937399886385628 -1.897 0.70600013877625 0.7059991120600673 -1.960901231598533e-07 -0.09937418843628756 -1.8971000000000002 0.7060004727121012 0.7059994492122452 -1.933959446927258e-07 -0.09937437795149062 -1.8972 0.7060008065758141 0.7059997862336536 -1.9066798316938471e-07 -0.09937456740948261 -1.8973000000000002 0.7060011403677737 0.7060001231239688 -1.879068762082603e-07 -0.09937475681028068 -1.8974000000000002 0.7060014740883582 0.7060004598828737 -1.8511326889750213e-07 -0.09937494615390208 -1.8975 0.706001807737939 0.7060007965100581 -1.8228781357293444e-07 -0.09937513544036389 -1.8976000000000002 0.7060021413168797 0.7060011330052189 -1.7943116972091167e-07 -0.09937532466968324 -1.8977 0.7060024748255369 0.7060014693680603 -1.7654400380831548e-07 -0.09937551384187727 -1.8978000000000002 0.7060028082642607 0.7060018055982937 -1.7362698911255192e-07 -0.09937570295696314 -1.8979000000000001 0.706003141633393 0.7060021416956381 -1.706808055879777e-07 -0.099375892014958 -1.898 0.7060034749332689 0.7060024776598192 -1.677061396872237e-07 -0.09937608101587897 -1.8981000000000001 0.7060038081642158 0.7060028134905705 -1.6470368422588644e-07 -0.09937626995974311 -1.8982 0.7060041413265538 0.7060031491876327 -1.616741381986475e-07 -0.0993764588465676 -1.8983 0.7060044744205949 0.7060034847507547 -1.5861820662661785e-07 -0.0993766476763695 -1.8984 0.7060048074466442 0.7060038201796928 -1.555366003908043e-07 -0.099376836449166 -1.8985 0.7060051404049987 0.7060041554742105 -1.5243003605169836e-07 -0.0993770251649742 -1.8986 0.7060054732959471 0.7060044906340794 -1.4929923571917192e-07 -0.09937721382381107 -1.8987 0.7060058061197714 0.7060048256590792 -1.4614492685818825e-07 -0.09937740242569382 -1.8988000000000003 0.7060061388767447 0.7060051605489968 -1.429678421187991e-07 -0.09937759097063947 -1.8989 0.7060064715671327 0.7060054953036277 -1.3976871917134592e-07 -0.09937777945866513 -1.899 0.7060068041911931 0.7060058299227747 -1.3654830055033484e-07 -0.09937796788978788 -1.8991000000000002 0.7060071367491758 0.7060061644062491 -1.3330733344973922e-07 -0.09937815626402478 -1.8992 0.7060074692413219 0.70600649875387 -1.300465695859565e-07 -0.09937834458139289 -1.8993000000000002 0.7060078016678648 0.7060068329654651 -1.267667650000498e-07 -0.09937853284190931 -1.8994000000000002 0.70600813402903 0.7060071670408693 -1.2346867988601018e-07 -0.09937872104559103 -1.8995 0.7060084663250342 0.7060075009799265 -1.2015307841554967e-07 -0.09937890919245514 -1.8996000000000002 0.7060087985560863 0.7060078347824884 -1.1682072856636361e-07 -0.09937909728251866 -1.8997 0.7060091307223871 0.7060081684484155 -1.1347240194345409e-07 -0.09937928531579869 -1.8998000000000002 0.7060094628241284 0.7060085019775761 -1.1010887358831045e-07 -0.09937947329231223 -1.8999000000000001 0.7060097948614938 0.706008835369847 -1.0673092181064103e-07 -0.09937966121207628 -1.9 0.706010126834659 0.7060091686251135 -1.0333932801837031e-07 -0.09937984907510791 -1.9001000000000001 0.7060104587437906 0.7060095017432692 -9.993487650947208e-08 -0.09938003688142412 -1.9002000000000001 0.7060107905890476 0.7060098347242161 -9.651835431844641e-08 -0.09938022463104194 -1.9003 0.7060111223705796 0.7060101675678643 -9.309055101682645e-08 -0.09938041232397835 -1.9004 0.7060114540885283 0.7060105002741333 -8.965225853450193e-08 -0.09938059996025037 -1.9005 0.7060117857430268 0.7060108328429504 -8.620427098364469e-08 -0.099380787539875 -1.9006 0.7060121173341991 0.7060111652742516 -8.274738446962387e-08 -0.09938097506286922 -1.9007 0.7060124488621613 0.7060114975679816 -7.928239690885991e-08 -0.09938116252925004 -1.9008000000000003 0.7060127803270206 0.7060118297240936 -7.581010783887232e-08 -0.09938134993903443 -1.9009 0.7060131117288759 0.7060121617425491 -7.233131824480737e-08 -0.09938153729223938 -1.901 0.7060134430678169 0.7060124936233186 -6.884683036645009e-08 -0.09938172458888185 -1.9011000000000002 0.7060137743439254 0.7060128253663811 -6.535744751607828e-08 -0.09938191182897883 -1.9012 0.7060141055572737 0.7060131569717241 -6.186397389284712e-08 -0.09938209901254724 -1.9013000000000002 0.7060144367079264 0.706013488439344 -5.836721439804113e-08 -0.09938228613960415 -1.9014000000000002 0.706014767795939 0.7060138197692456 -5.4867974449241894e-08 -0.09938247321016647 -1.9015 0.706015098821358 0.706014150961442 -5.1367059794929504e-08 -0.09938266022425109 -1.9016000000000002 0.7060154297842218 0.706014482015956 -4.78652763297345e-08 -0.09938284718187504 -1.9017 0.7060157606845598 0.7060148129328174 -4.436342990714196e-08 -0.09938303408305516 -1.9018000000000002 0.7060160915223932 0.7060151437120662 -4.086232615439783e-08 -0.09938322092780845 -1.9019000000000001 0.7060164222977336 0.7060154743537501 -3.736277029214516e-08 -0.09938340771615183 -1.902 0.7060167530105852 0.706015804857926 -3.386556694166647e-08 -0.09938359444810219 -1.9021000000000001 0.7060170836609427 0.7060161352246588 -3.037151994483844e-08 -0.09938378112367648 -1.9022000000000001 0.7060174142487925 0.7060164654540226 -2.6881432178956985e-08 -0.09938396774289163 -1.9023 0.7060177447741125 0.7060167955460998 -2.339610536902792e-08 -0.09938415430576454 -1.9024 0.7060180752368714 0.7060171255009811 -1.991633990974101e-08 -0.09938434081231208 -1.9025 0.7060184056370302 0.7060174553187664 -1.644293467530089e-08 -0.09938452726255118 -1.9026 0.7060187359745409 0.7060177849995635 -1.2976686840967394e-08 -0.09938471365649874 -1.9027 0.7060190662493465 0.7060181145434893 -9.518391696789613e-09 -0.09938489999417163 -1.9028000000000003 0.7060193964613826 0.7060184439506687 -6.068842467628344e-09 -0.09938508627558675 -1.9029 0.706019726610575 0.7060187732212353 -2.628830128408033e-09 -0.09938527250076096 -1.903 0.7060200566968424 0.7060191023553313 8.008567689218871e-10 -0.09938545866971117 -1.9031000000000002 0.7060203867200939 0.7060194313531067 4.219432294880199e-09 -0.09938564478245421 -1.9032 0.7060207166802308 0.7060197602147209 7.626113296410608e-09 -0.09938583083900693 -1.9033000000000002 0.7060210465771459 0.7060200889403407 1.1020119600711753e-08 -0.09938601683938626 -1.9034 0.7060213764107238 0.7060204175301419 1.4400674175699124e-08 -0.09938620278360902 -1.9035 0.7060217061808405 0.706020745984308 1.776700332169201e-08 -0.09938638867169204 -1.9036000000000002 0.7060220358873641 0.7060210743030311 2.1118336831875417e-08 -0.09938657450365222 -1.9037 0.7060223655301537 0.7060214024865115 2.4453908193527996e-08 -0.09938676027950631 -1.9038000000000002 0.7060226951090613 0.7060217305349579 2.7772954729402e-08 -0.09938694599927123 -1.9039000000000001 0.7060230246239301 0.7060220584485863 3.1074717805890106e-08 -0.09938713166296377 -1.904 0.7060233540745954 0.7060223862276216 3.4358442988283167e-08 -0.09938731727060077 -1.9041000000000001 0.7060236834608842 0.7060227138722963 3.7623380215109914e-08 -0.09938750282219902 -1.9042000000000001 0.706024012782616 0.7060230413828512 4.086878396640514e-08 -0.09938768831777536 -1.9043 0.7060243420396017 0.7060233687595348 4.409391344412095e-08 -0.09938787375734659 -1.9044 0.706024671231645 0.7060236960026034 4.729803272998656e-08 -0.09938805914092955 -1.9045 0.7060250003585411 0.7060240231123214 5.048041096245015e-08 -0.09938824446854096 -1.9046 0.7060253294200778 0.7060243500889607 5.36403224980081e-08 -0.09938842974019768 -1.9047 0.7060256584160353 0.7060246769328011 5.677704707079956e-08 -0.09938861495591648 -1.9048000000000003 0.7060259873461856 0.7060250036441303 5.98898699730177e-08 -0.09938880011571419 -1.9049 0.7060263162102935 0.7060253302232429 6.297808221103485e-08 -0.09938898521960748 -1.905 0.7060266450081167 0.7060256566704413 6.604098064764974e-08 -0.09938917026761325 -1.9051000000000002 0.7060269737394045 0.7060259829860356 6.907786819811135e-08 -0.09938935525974821 -1.9052 0.706027302403899 0.7060263091703431 7.208805395848839e-08 -0.0993895401960291 -1.9053000000000002 0.7060276310013355 0.7060266352236884 7.507085337046804e-08 -0.0993897250764727 -1.9054 0.7060279595314415 0.7060269611464036 7.802558839309359e-08 -0.0993899099010958 -1.9055 0.7060282879939377 0.7060272869388278 8.095158763460342e-08 -0.09939009466991511 -1.9056000000000002 0.706028616388537 0.706027612601307 8.384818650855608e-08 -0.09939027938294738 -1.9057 0.7060289447149461 0.7060279381341943 8.67147273934249e-08 -0.09939046404020932 -1.9058000000000002 0.7060292729728643 0.7060282635378504 8.955055979045778e-08 -0.09939064864171775 -1.9059000000000001 0.7060296011619838 0.7060285888126421 9.2355040438169e-08 -0.09939083318748929 -1.906 0.7060299292819905 0.7060289139589435 9.512753351009762e-08 -0.09939101767754079 -1.9061000000000001 0.7060302573325631 0.7060292389771349 9.786741069980898e-08 -0.09939120211188887 -1.9062000000000001 0.7060305853133739 0.7060295638676037 1.0057405140304065e-07 -0.09939138649055032 -1.9063 0.7060309132240886 0.7060298886307438 1.0324684284954144e-07 -0.09939157081354179 -1.9064 0.7060312410643661 0.7060302132669551 1.0588518024184923e-07 -0.09939175508087998 -1.9065 0.7060315688338596 0.7060305377766445 1.0848846685937441e-07 -0.09939193929258162 -1.9066 0.7060318965322152 0.7060308621602249 1.1105611426309725e-07 -0.09939212344866345 -1.9067 0.7060322241590734 0.7060311864181155 1.1358754237536517e-07 -0.09939230754914209 -1.9068000000000003 0.7060325517140682 0.7060315105507413 1.1608217960826228e-07 -0.09939249159403425 -1.9069 0.7060328791968276 0.7060318345585339 1.185394630197345e-07 -0.09939267558335661 -1.907 0.7060332066069739 0.7060321584419301 1.2095883843155075e-07 -0.09939285951712584 -1.9071000000000002 0.7060335339441233 0.7060324822013733 1.2333976054726414e-07 -0.09939304339535865 -1.9072 0.7060338612078865 0.706032805837312 1.2568169308058152e-07 -0.09939322721807167 -1.9073000000000002 0.706034188397868 0.7060331293502005 1.2798410888720246e-07 -0.09939341098528154 -1.9074 0.7060345155136679 0.7060334527404987 1.3024649004461653e-07 -0.09939359469700497 -1.9075 0.7060348425548796 0.7060337760086721 1.3246832801516728e-07 -0.09939377835325858 -1.9076000000000002 0.7060351695210916 0.7060340991551912 1.3464912373278848e-07 -0.09939396195405902 -1.9077 0.7060354964118872 0.7060344221805319 1.367883877174958e-07 -0.0993941454994229 -1.9078000000000002 0.7060358232268449 0.7060347450851752 1.3888564021416472e-07 -0.09939432898936688 -1.9079000000000002 0.7060361499655374 0.7060350678696073 1.4094041125151113e-07 -0.09939451242390761 -1.908 0.7060364766275333 0.7060353905343191 1.4295224078433866e-07 -0.0993946958030617 -1.9081000000000001 0.7060368032123958 0.7060357130798061 1.4492067876986647e-07 -0.09939487912684579 -1.9082000000000001 0.7060371297196835 0.7060360355065689 1.468452852995683e-07 -0.09939506239527644 -1.9083 0.7060374561489505 0.7060363578151125 1.4872563067203082e-07 -0.09939524560837032 -1.9084 0.7060377824997467 0.7060366800059463 1.505612954900981e-07 -0.09939542876614402 -1.9085 0.7060381087716171 0.7060370020795843 1.5235187076495516e-07 -0.09939561186861415 -1.9086 0.7060384349641027 0.7060373240365445 1.5409695800980283e-07 -0.0993957949157973 -1.9087 0.7060387610767399 0.7060376458773492 1.55796169302308e-07 -0.09939597790771003 -1.9088000000000003 0.7060390871090618 0.7060379676025246 1.574491274268508e-07 -0.09939616084436896 -1.9089 0.7060394130605971 0.7060382892126008 1.5905546588493302e-07 -0.09939634372579066 -1.909 0.706039738930871 0.7060386107081118 1.6061482903048652e-07 -0.0993965265519917 -1.9091000000000002 0.706040064719405 0.7060389320895955 1.621268721357927e-07 -0.09939670932298872 -1.9092 0.7060403904257162 0.7060392533575928 1.635912614504631e-07 -0.09939689203879822 -1.9093000000000002 0.7060407160493195 0.7060395745126482 1.6500767430205343e-07 -0.09939707469943677 -1.9094 0.7060410415897256 0.7060398955553098 1.663757991203496e-07 -0.09939725730492092 -1.9095 0.706041367046442 0.7060402164861288 1.6769533557961513e-07 -0.09939743985526726 -1.9096000000000002 0.7060416924189741 0.7060405373056593 1.6896599458818273e-07 -0.09939762235049232 -1.9097 0.706042017706823 0.7060408580144585 1.7018749839600722e-07 -0.09939780479061265 -1.9098000000000002 0.7060423429094875 0.7060411786130864 1.7135958065711554e-07 -0.09939798717564473 -1.9099000000000002 0.706042668026464 0.7060414991021056 1.7248198645042345e-07 -0.09939816950560515 -1.91 0.7060429930572458 0.7060418194820814 1.7355447239075783e-07 -0.09939835178051046 -1.9101000000000001 0.7060433180013242 0.7060421397535817 1.7457680663579556e-07 -0.09939853400037713 -1.9102000000000001 0.7060436428581878 0.7060424599171764 1.7554876895545246e-07 -0.09939871616522172 -1.9103 0.7060439676273228 0.7060427799734376 1.7647015075616945e-07 -0.09939889827506067 -1.9104 0.7060442923082141 0.7060430999229399 1.7734075516417924e-07 -0.0993990803299106 -1.9105 0.7060446169003436 0.7060434197662598 1.781603970289758e-07 -0.09939926232978792 -1.9106 0.7060449414031917 0.706043739503975 1.7892890296841713e-07 -0.09939944427470915 -1.9107 0.7060452658162376 0.7060440591366659 1.7964611147627818e-07 -0.0993996261646908 -1.9108000000000003 0.7060455901389584 0.7060443786649133 1.803118728389841e-07 -0.09939980799974935 -1.9109 0.70604591437083 0.7060446980893007 1.809260492570408e-07 -0.09939998977990129 -1.911 0.7060462385113265 0.7060450174104121 1.814885148276879e-07 -0.09940017150516313 -1.9111000000000002 0.7060465625599213 0.7060453366288328 1.8199915557612356e-07 -0.09940035317555128 -1.9112 0.7060468865160865 0.7060456557451493 1.8245786949019904e-07 -0.09940053479108227 -1.9113000000000002 0.706047210379293 0.7060459747599493 1.828645665273576e-07 -0.09940071635177251 -1.9114 0.7060475341490109 0.7060462936738208 1.8321916865279841e-07 -0.09940089785763846 -1.9115 0.7060478578247108 0.7060466124873526 1.8352160983600707e-07 -0.09940107930869667 -1.9116000000000002 0.7060481814058612 0.7060469312011343 1.8377183607851122e-07 -0.0994012607049635 -1.9117 0.7060485048919305 0.7060472498157556 1.839698053965333e-07 -0.0994014420464554 -1.9118000000000002 0.7060488282823871 0.7060475683318068 1.841154878418072e-07 -0.0994016233331888 -1.9119000000000002 0.7060491515766993 0.7060478867498786 1.8420886550157833e-07 -0.0994018045651802 -1.912 0.7060494747743351 0.706048205070561 1.8424993251248134e-07 -0.09940198574244599 -1.9121000000000001 0.7060497978747624 0.706048523294444 1.842386950501318e-07 -0.09940216686500256 -1.9122000000000001 0.7060501208774499 0.7060488414221182 1.8417517130137062e-07 -0.09940234793286638 -1.9123 0.706050443781866 0.7060491594541731 1.8405939150589745e-07 -0.09940252894605384 -1.9124 0.70605076658748 0.7060494773911978 1.8389139790422893e-07 -0.09940270990458139 -1.9125 0.7060510892937618 0.7060497952337812 1.8367124474116814e-07 -0.0994028908084654 -1.9126 0.7060514119001817 0.706050112982511 1.8339899823111017e-07 -0.09940307165772229 -1.9127 0.7060517344062109 0.7060504306379742 1.8307473656151152e-07 -0.09940325245236845 -1.9128000000000003 0.7060520568113218 0.7060507482007569 1.82698549868604e-07 -0.09940343319242023 -1.9129 0.7060523791149877 0.7060510656714439 1.8227054023045586e-07 -0.09940361387789412 -1.913 0.7060527013166835 0.706051383050619 1.8179082156982718e-07 -0.09940379450880639 -1.9131000000000002 0.7060530234158847 0.706051700338864 1.8125951971315057e-07 -0.09940397508517346 -1.9132 0.7060533454120692 0.7060520175367603 1.8067677229338663e-07 -0.09940415560701171 -1.9133000000000002 0.706053667304716 0.7060523346448866 1.8004272873961558e-07 -0.0994043360743375 -1.9134 0.7060539890933057 0.7060526516638204 1.7935755025969002e-07 -0.0994045164871672 -1.9135 0.7060543107773215 0.7060529685941372 1.7862140976390717e-07 -0.09940469684551717 -1.9136000000000002 0.7060546323562474 0.7060532854364108 1.7783449185113098e-07 -0.09940487714940376 -1.9137 0.7060549538295708 0.706053602191212 1.7699699272205605e-07 -0.09940505739884334 -1.9138000000000002 0.7060552751967801 0.7060539188591104 1.7610912015839086e-07 -0.0994052375938522 -1.9139000000000002 0.7060555964573669 0.7060542354406725 1.7517109348469395e-07 -0.09940541773444665 -1.914 0.7060559176108255 0.7060545519364623 1.7418314350939323e-07 -0.09940559782064312 -1.9141000000000001 0.706056238656652 0.7060548683470417 1.7314551244151932e-07 -0.0994057778524579 -1.9142000000000001 0.7060565595943458 0.7060551846729695 1.7205845383519436e-07 -0.0994059578299073 -1.9143000000000001 0.7060568804234086 0.7060555009148017 1.7092223256881534e-07 -0.09940613775300766 -1.9144 0.7060572011433458 0.7060558170730911 1.697371247409707e-07 -0.09940631762177525 -1.9145 0.7060575217536655 0.7060561331483877 1.685034176183986e-07 -0.09940649743622643 -1.9146 0.7060578422538786 0.7060564491412382 1.6722140956659803e-07 -0.09940667719637745 -1.9147 0.7060581626435003 0.7060567650521861 1.658914099630926e-07 -0.09940685690224468 -1.9148000000000003 0.7060584829220484 0.706057080881771 1.6451373915579715e-07 -0.09940703655384436 -1.9149 0.7060588030890447 0.706057396630529 1.6308872833811772e-07 -0.0994072161511928 -1.915 0.7060591231440145 0.7060577122989933 1.6161671950731815e-07 -0.0994073956943063 -1.9151000000000002 0.706059443086487 0.7060580278876918 1.600980654055395e-07 -0.09940757518320108 -1.9152 0.7060597629159951 0.7060583433971501 1.5853312934979713e-07 -0.0994077546178935 -1.9153000000000002 0.7060600826320761 0.7060586588278889 1.5692228522851126e-07 -0.09940793399839978 -1.9154 0.7060604022342709 0.7060589741804245 1.5526591735925965e-07 -0.0994081133247362 -1.9155 0.7060607217221251 0.7060592894552695 1.535644204506137e-07 -0.099408292596919 -1.9156000000000002 0.7060610410951883 0.7060596046529319 1.5181819946682995e-07 -0.09940847181496444 -1.9157 0.7060613603530151 0.7060599197739154 1.5002766952029734e-07 -0.09940865097888882 -1.9158000000000002 0.7060616794951642 0.7060602348187188 1.481932558125565e-07 -0.09940883008870832 -1.9159000000000002 0.7060619985211987 0.7060605497878365 1.4631539351286915e-07 -0.09940900914443922 -1.916 0.706062317430687 0.7060608646817581 1.443945276506653e-07 -0.09940918814609774 -1.9161000000000001 0.7060626362232028 0.7060611795009678 1.4243111304268474e-07 -0.09940936709370012 -1.9162000000000001 0.7060629548983237 0.7060614942459456 1.4042561413338261e-07 -0.09940954598726259 -1.9163000000000001 0.7060632734556331 0.7060618089171655 1.383785048977848e-07 -0.09940972482680138 -1.9164 0.7060635918947193 0.7060621235150972 1.3629026878597683e-07 -0.09940990361233268 -1.9165 0.7060639102151762 0.7060624380402043 1.341613985496315e-07 -0.09941008234387272 -1.9166 0.706064228416603 0.7060627524929456 1.3199239612751712e-07 -0.09941026102143773 -1.9167 0.7060645464986041 0.7060630668737741 1.2978377256223084e-07 -0.09941043964504387 -1.9168000000000003 0.7060648644607894 0.7060633811831368 1.2753604783713457e-07 -0.09941061821470731 -1.9169 0.7060651823027753 0.7060636954214761 1.2524975081043555e-07 -0.09941079673044434 -1.917 0.7060655000241832 0.7060640095892275 1.2292541904171395e-07 -0.09941097519227109 -1.9171 0.7060658176246404 0.7060643236868211 1.2056359867396171e-07 -0.09941115360020371 -1.9172 0.7060661351037807 0.7060646377146813 1.1816484430174357e-07 -0.09941133195425844 -1.9173000000000002 0.7060664524612434 0.7060649516732259 1.1572971888793027e-07 -0.09941151025445145 -1.9174 0.706066769696674 0.706065265562867 1.1325879357287905e-07 -0.09941168850079893 -1.9175 0.7060670868097247 0.7060655793840098 1.1075264757381964e-07 -0.09941186669331697 -1.9176000000000002 0.7060674038000534 0.706065893137054 1.0821186801832083e-07 -0.09941204483202176 -1.9177 0.7060677206673246 0.7060662068223924 1.0563704986102374e-07 -0.09941222291692947 -1.9178000000000002 0.7060680374112093 0.7060665204404114 1.0302879569976109e-07 -0.09941240094805621 -1.9179000000000002 0.7060683540313851 0.7060668339914911 1.0038771562637105e-07 -0.09941257892541822 -1.918 0.7060686705275361 0.7060671474760044 9.771442711567491e-08 -0.0994127568490315 -1.9181000000000001 0.7060689868993533 0.706067460894318 9.500955487282137e-08 -0.09941293471891231 -1.9182000000000001 0.7060693031465344 0.7060677742467919 9.227373069797817e-08 -0.09941311253507673 -1.9183000000000001 0.7060696192687836 0.7060680875337785 8.950759328510416e-08 -0.09941329029754091 -1.9184 0.7060699352658127 0.7060684007556237 8.671178815256031e-08 -0.09941346800632091 -1.9185 0.7060702511373398 0.7060687139126667 8.388696742626933e-08 -0.09941364566143289 -1.9186 0.7060705668830908 0.7060690270052391 8.103378974083641e-08 -0.099413823262893 -1.9187 0.7060708825027979 0.7060693400336655 7.815292003485186e-08 -0.09941400081071727 -1.9188000000000003 0.7060711979962013 0.7060696529982635 7.524502942599098e-08 -0.09941417830492183 -1.9189 0.706071513363048 0.7060699658993432 7.231079505662374e-08 -0.09941435574552282 -1.919 0.7060718286030921 0.7060702787372075 6.935089992554655e-08 -0.09941453313253629 -1.9191 0.706072143716096 0.7060705915121517 6.636603271797936e-08 -0.09941471046597836 -1.9192 0.7060724587018284 0.7060709042244635 6.335688768066561e-08 -0.09941488774586507 -1.9193000000000002 0.7060727735600666 0.7060712168744239 6.032416443278732e-08 -0.09941506497221257 -1.9194 0.7060730882905946 0.7060715294623052 5.726856780984002e-08 -0.09941524214503686 -1.9195 0.7060734028932042 0.7060718419883727 5.419080769536455e-08 -0.099415419264354 -1.9196000000000002 0.7060737173676954 0.7060721544528838 5.109159887002612e-08 -0.09941559633018011 -1.9197 0.7060740317138754 0.7060724668560889 4.7971660834672525e-08 -0.09941577334253124 -1.9198000000000002 0.7060743459315589 0.7060727791982295 4.483171763165761e-08 -0.09941595030142342 -1.9199000000000002 0.7060746600205693 0.7060730914795399 4.1672497711267575e-08 -0.09941612720687269 -1.92 0.7060749739807373 0.7060734037002463 3.8494733728758335e-08 -0.09941630405889515 -1.9201000000000001 0.7060752878119013 0.7060737158605672 3.5299162396904005e-08 -0.0994164808575068 -1.9202000000000001 0.706075601513908 0.7060740279607128 3.208652428997316e-08 -0.09941665760272364 -1.9203000000000001 0.7060759150866123 0.7060743400008858 2.885756370842041e-08 -0.09941683429456177 -1.9204 0.7060762285298764 0.7060746519812804 2.5613028475923727e-08 -0.09941701093303718 -1.9205 0.7060765418435713 0.7060749639020831 2.2353669778055196e-08 -0.09941718751816592 -1.9206 0.7060768550275754 0.7060752757634718 1.9080241990543367e-08 -0.09941736404996399 -1.9207 0.7060771680817759 0.706075587565617 1.5793502498862022e-08 -0.09941754052844737 -1.9208000000000003 0.7060774810060677 0.7060758993086802 1.2494211521288379e-08 -0.0994177169536321 -1.9209 0.7060777938003537 0.7060762109928151 9.183131949308532e-09 -0.09941789332553415 -1.921 0.706078106464546 0.7060765226181678 5.861029153328423e-09 -0.0994180696441696 -1.9211 0.7060784189985639 0.7060768341848748 2.5286708074667708e-09 -0.09941824590955439 -1.9212 0.7060787314023351 0.7060771456930656 -8.131732787131085e-10 -0.09941842212170449 -1.9213000000000002 0.7060790436757958 0.7060774571428603 -4.16373133541037e-09 -0.09941859828063587 -1.9214 0.7060793558188907 0.7060777685343718 -7.522229830345117e-09 -0.0994187743863646 -1.9215 0.7060796678315725 0.7060780798677038 -1.0887893630087686e-08 -0.09941895043890653 -1.9216000000000002 0.7060799797138023 0.706078391142952 -1.4259946180469885e-08 -0.09941912643827772 -1.9217 0.7060802914655493 0.7060787023602041 -1.7637609690032002e-08 -0.09941930238449409 -1.9218000000000002 0.7060806030867914 0.7060790135195387 -2.1020105311735093e-08 -0.09941947827757161 -1.9219000000000002 0.7060809145775151 0.7060793246210266 -2.4406653311662835e-08 -0.09941965411752629 -1.922 0.7060812259377145 0.7060796356647299 -2.7796473262009513e-08 -0.099419829904374 -1.9221000000000001 0.7060815371673924 0.7060799466507026 -3.1188784210649245e-08 -0.09942000563813069 -1.9222000000000001 0.7060818482665605 0.70608025757899 -3.458280486761875e-08 -0.09942018131881236 -1.9223000000000001 0.706082159235238 0.7060805684496292 -3.797775378097494e-08 -0.09942035694643492 -1.9224 0.7060824700734529 0.7060808792626487 -4.137284951796511e-08 -0.09942053252101427 -1.9225 0.7060827807812418 0.706081190018069 -4.476731084633264e-08 -0.09942070804256635 -1.9226 0.7060830913586496 0.7060815007159019 -4.816035691036433e-08 -0.09942088351110712 -1.9227 0.7060834018057289 0.7060818113561509 -5.155120741417475e-08 -0.09942105892665243 -1.9228000000000003 0.7060837121225414 0.7060821219388111 -5.49390827987023e-08 -0.09942123428921826 -1.9229 0.7060840223091571 0.7060824324638695 -5.8323204422689595e-08 -0.09942140959882051 -1.923 0.7060843323656538 0.7060827429313041 -6.170279473818874e-08 -0.09942158485547503 -1.9231 0.7060846422921181 0.7060830533410855 -6.507707747595987e-08 -0.0994217600591978 -1.9232 0.7060849520886447 0.7060833636931749 -6.844527781742563e-08 -0.0994219352100046 -1.9233000000000002 0.7060852617553366 0.7060836739875264 -7.180662256901088e-08 -0.0994221103079114 -1.9234 0.7060855712923051 0.7060839842240848 -7.516034035296229e-08 -0.0994222853529341 -1.9235 0.7060858806996698 0.7060842944027872 -7.850566177605017e-08 -0.09942246034508853 -1.9236000000000002 0.7060861899775585 0.7060846045235623 -8.1841819597403e-08 -0.09942263528439059 -1.9237 0.7060864991261068 0.7060849145863302 -8.51680489232301e-08 -0.09942281017085608 -1.9238000000000002 0.7060868081454592 0.7060852245910039 -8.848358736424783e-08 -0.09942298500450099 -1.9239000000000002 0.7060871170357679 0.7060855345374869 -9.178767522259601e-08 -0.0994231597853411 -1.924 0.7060874257971931 0.7060858444256755 -9.507955566531029e-08 -0.09942333451339225 -1.9241000000000001 0.7060877344299032 0.7060861542554577 -9.835847488478405e-08 -0.09942350918867034 -1.9242000000000001 0.7060880429340749 0.7060864640267133 -1.0162368228872065e-07 -0.0994236838111912 -1.9243000000000001 0.7060883513098924 0.7060867737393144 -1.0487443065625851e-07 -0.09942385838097066 -1.9244 0.7060886595575484 0.7060870833931243 -1.081099763244539e-07 -0.09942403289802455 -1.9245 0.706088967677243 0.7060873929879998 -1.1132957934006926e-07 -0.09942420736236877 -1.9246 0.7060892756691847 0.7060877025237884 -1.1453250365472956e-07 -0.09942438177401909 -1.9247 0.7060895835335892 0.7060880120003302 -1.177180172541592e-07 -0.09942455613299131 -1.9248000000000003 0.706089891270681 0.706088321417458 -1.208853923680836e-07 -0.09942473043930135 -1.9249 0.7060901988806911 0.7060886307749958 -1.240339056116091e-07 -0.09942490469296489 -1.925 0.7060905063638591 0.706088940072761 -1.271628381413481e-07 -0.09942507889399779 -1.9251 0.7060908137204317 0.7060892493105628 -1.3027147586185117e-07 -0.09942525304241585 -1.9252 0.7060911209506637 0.7060895584882028 -1.333591095348946e-07 -0.09942542713823492 -1.9253000000000002 0.7060914280548172 0.7060898676054749 -1.3642503497897362e-07 -0.09942560118147076 -1.9254 0.7060917350331617 0.7060901766621659 -1.3946855322022333e-07 -0.09942577517213914 -1.9255 0.7060920418859742 0.7060904856580548 -1.4248897062946186e-07 -0.0994259491102559 -1.9256000000000002 0.7060923486135393 0.7060907945929134 -1.4548559912688774e-07 -0.09942612299583677 -1.9257 0.7060926552161483 0.706091103466506 -1.4845775629136748e-07 -0.09942629682889753 -1.9258000000000002 0.7060929616941001 0.7060914122785903 -1.514047655477857e-07 -0.09942647060945398 -1.9259000000000002 0.7060932680477009 0.7060917210289157 -1.5432595630582302e-07 -0.09942664433752185 -1.926 0.7060935742772638 0.7060920297172253 -1.5722066410740754e-07 -0.09942681801311692 -1.9261000000000001 0.7060938803831092 0.7060923383432549 -1.6008823079498302e-07 -0.09942699163625494 -1.9262000000000001 0.7060941863655641 0.7060926469067332 -1.6292800466069512e-07 -0.09942716520695168 -1.9263000000000001 0.7060944922249628 0.7060929554073823 -1.6573934056088313e-07 -0.09942733872522286 -1.9264000000000001 0.706094797961646 0.7060932638449169 -1.685216001190426e-07 -0.09942751219108421 -1.9265 0.7060951035759617 0.7060935722190458 -1.712741518073574e-07 -0.09942768560455158 -1.9266 0.7060954090682643 0.7060938805294703 -1.739963711531317e-07 -0.0994278589656406 -1.9267 0.7060957144389144 0.7060941887758854 -1.7668764083419997e-07 -0.09942803227436704 -1.9268000000000003 0.7060960196882795 0.7060944969579794 -1.7934735082117403e-07 -0.0994282055307466 -1.9269 0.7060963248167338 0.7060948050754343 -1.819748985630587e-07 -0.09942837873479499 -1.927 0.7060966298246578 0.7060951131279257 -1.8456968905317117e-07 -0.09942855188652795 -1.9271 0.7060969347124375 0.7060954211151231 -1.8713113501128698e-07 -0.09942872498596118 -1.9272 0.7060972394804663 0.7060957290366892 -1.896586570224179e-07 -0.0994288980331104 -1.9273000000000002 0.7060975441291426 0.7060960368922811 -1.9215168362007873e-07 -0.09942907102799131 -1.9274 0.7060978486588714 0.7060963446815498 -1.9460965148404563e-07 -0.09942924397061959 -1.9275 0.7060981530700636 0.7060966524041401 -1.9703200548198962e-07 -0.09942941686101092 -1.9276000000000002 0.7060984573631359 0.7060969600596911 -1.9941819888458223e-07 -0.09942958969918099 -1.9277 0.706098761538511 0.7060972676478364 -2.0176769342100664e-07 -0.09942976248514557 -1.9278000000000002 0.7060990655966165 0.7060975751682033 -2.0407995942814394e-07 -0.09942993521892018 -1.9279000000000002 0.7060993695378863 0.7060978826204138 -2.0635447598588152e-07 -0.09943010790052059 -1.928 0.7060996733627596 0.7060981900040849 -2.0859073099344094e-07 -0.09943028052996249 -1.9281000000000001 0.7060999770716812 0.7060984973188273 -2.1078822132203356e-07 -0.09943045310726151 -1.9282000000000001 0.7061002806651002 0.7060988045642473 -2.129464528981273e-07 -0.09943062563243327 -1.9283000000000001 0.7061005841434723 0.7060991117399456 -2.1506494084569394e-07 -0.09943079810549355 -1.9284000000000001 0.706100887507257 0.7060994188455174 -2.171432095660064e-07 -0.09943097052645783 -1.9285 0.7061011907569197 0.7060997258805535 -2.1918079285213055e-07 -0.09943114289534188 -1.9286 0.7061014938929301 0.7061000328446397 -2.2117723402770295e-07 -0.09943131521216131 -1.9287 0.7061017969157629 0.7061003397373569 -2.2313208598856438e-07 -0.09943148747693176 -1.9288000000000003 0.7061020998258976 0.7061006465582813 -2.2504491133806814e-07 -0.09943165968966884 -1.9289 0.7061024026238178 0.7061009533069844 -2.26915282494633e-07 -0.09943183185038816 -1.929 0.7061027053100122 0.7061012599830336 -2.287427817646015e-07 -0.09943200395910538 -1.9291 0.706103007884973 0.706101566585992 -2.3052700144979288e-07 -0.09943217601583614 -1.9292 0.706103310349198 0.7061018731154175 -2.3226754392036142e-07 -0.09943234802059601 -1.9293000000000002 0.7061036127031877 0.7061021795708649 -2.3396402171887987e-07 -0.09943251997340062 -1.9294 0.7061039149474473 0.7061024859518843 -2.356160576470756e-07 -0.09943269187426552 -1.9295 0.7061042170824858 0.7061027922580223 -2.3722328486297517e-07 -0.09943286372320637 -1.9296000000000002 0.7061045191088162 0.7061030984888219 -2.387853469051904e-07 -0.09943303552023877 -1.9297 0.7061048210269548 0.7061034046438213 -2.403018978629212e-07 -0.09943320726537824 -1.9298000000000002 0.706105122837422 0.7061037107225563 -2.4177260233779196e-07 -0.09943337895864045 -1.9299000000000002 0.7061054245407408 0.7061040167245589 -2.431971356554874e-07 -0.09943355060004093 -1.93 0.7061057261374384 0.7061043226493573 -2.44575183789425e-07 -0.09943372218959526 -1.9301000000000001 0.7061060276280451 0.7061046284964767 -2.459064435481051e-07 -0.09943389372731903 -1.9302000000000001 0.7061063290130938 0.7061049342654394 -2.4719062258551916e-07 -0.09943406521322777 -1.9303000000000001 0.7061066302931208 0.7061052399557644 -2.4842743947400825e-07 -0.09943423664733704 -1.9304000000000001 0.7061069314686654 0.7061055455669679 -2.4961662377018246e-07 -0.09943440802966247 -1.9305 0.7061072325402693 0.7061058510985636 -2.5075791608430986e-07 -0.09943457936021957 -1.9306 0.7061075335084772 0.7061061565500621 -2.51851068115011e-07 -0.09943475063902392 -1.9307 0.7061078343738356 0.7061064619209716 -2.528958426943617e-07 -0.09943492186609096 -1.9308 0.7061081351368945 0.7061067672107981 -2.5389201389197646e-07 -0.09943509304143633 -1.9309 0.706108435798205 0.706107072419045 -2.5483936698725285e-07 -0.09943526416507553 -1.931 0.7061087363583214 0.706107377545214 -2.5573769860468e-07 -0.09943543523702408 -1.9311 0.7061090368177994 0.706107682588804 -2.565868166583274e-07 -0.09943560625729755 -1.9312 0.7061093371771967 0.7061079875493127 -2.5738654051490895e-07 -0.0994357772259114 -1.9313000000000002 0.7061096374370729 0.7061082924262354 -2.5813670088276064e-07 -0.09943594814288115 -1.9314 0.7061099375979893 0.7061085972190664 -2.5883713997490454e-07 -0.09943611900822236 -1.9315 0.7061102376605088 0.7061089019272979 -2.5948771148129324e-07 -0.09943628982195052 -1.9316000000000002 0.7061105376251955 0.7061092065504206 -2.6008828060003486e-07 -0.0994364605840811 -1.9317 0.7061108374926148 0.7061095110879243 -2.606387240998431e-07 -0.09943663129462964 -1.9318000000000002 0.7061111372633335 0.7061098155392974 -2.6113893029922064e-07 -0.09943680195361158 -1.9319000000000002 0.7061114369379193 0.7061101199040273 -2.6158879910462285e-07 -0.09943697256104246 -1.932 0.7061117365169408 0.7061104241816003 -2.619882420624997e-07 -0.09943714311693776 -1.9321000000000002 0.7061120360009674 0.7061107283715022 -2.6233718232460124e-07 -0.09943731362131294 -1.9322000000000001 0.7061123353905694 0.7061110324732176 -2.626355547000192e-07 -0.09943748407418349 -1.9323000000000001 0.7061126346863172 0.7061113364862313 -2.6288330566212603e-07 -0.09943765447556485 -1.9324000000000001 0.7061129338887822 0.7061116404100265 -2.63080393334697e-07 -0.09943782482547252 -1.9325 0.7061132329985356 0.7061119442440874 -2.6322678750231865e-07 -0.09943799512392196 -1.9326 0.7061135320161488 0.7061122479878972 -2.63322469652022e-07 -0.09943816537092856 -1.9327 0.7061138309421937 0.7061125516409392 -2.6336743291777154e-07 -0.09943833556650787 -1.9328 0.7061141297772415 0.7061128552026967 -2.633616821394458e-07 -0.09943850571067524 -1.9329 0.7061144285218637 0.7061131586726535 -2.633052337969177e-07 -0.09943867580344616 -1.933 0.7061147271766313 0.7061134620502935 -2.6319811602393273e-07 -0.09943884584483609 -1.9331 0.7061150257421148 0.7061137653351008 -2.630403686428029e-07 -0.09943901583486042 -1.9332 0.7061153242188842 0.7061140685265607 -2.628320430950182e-07 -0.09943918577353464 -1.9333000000000002 0.7061156226075087 0.7061143716241586 -2.625732024343075e-07 -0.09943935566087413 -1.9334 0.7061159209085566 0.7061146746273805 -2.6226392134745535e-07 -0.09943952549689426 -1.9335 0.7061162191225956 0.7061149775357145 -2.619042860710352e-07 -0.09943969528161056 -1.9336000000000002 0.7061165172501922 0.7061152803486485 -2.6149439443651223e-07 -0.09943986501503838 -1.9337 0.7061168152919113 0.7061155830656719 -2.61034355790446e-07 -0.09944003469719306 -1.9338000000000002 0.7061171132483168 0.7061158856862761 -2.6052429099795993e-07 -0.09944020432809013 -1.9339000000000002 0.7061174111199713 0.706116188209953 -2.599643323802914e-07 -0.0994403739077449 -1.934 0.7061177089074357 0.7061164906361965 -2.5935462374254703e-07 -0.09944054343617278 -1.9341000000000002 0.706118006611269 0.7061167929645025 -2.5869532024186404e-07 -0.09944071291338917 -1.9342000000000001 0.7061183042320285 0.7061170951943682 -2.5798658846026834e-07 -0.09944088233940945 -1.9343000000000001 0.7061186017702699 0.7061173973252926 -2.5722860623814126e-07 -0.099441051714249 -1.9344000000000001 0.7061188992265464 0.7061176993567773 -2.5642156275401673e-07 -0.09944122103792319 -1.9345 0.7061191966014091 0.7061180012883252 -2.555656583788646e-07 -0.09944139031044737 -1.9346 0.7061194938954071 0.7061183031194428 -2.5466110468649883e-07 -0.09944155953183695 -1.9347 0.7061197911090866 0.7061186048496377 -2.5370812439112767e-07 -0.09944172870210725 -1.9348 0.7061200882429919 0.7061189064784206 -2.5270695127449505e-07 -0.09944189782127359 -1.9349 0.706120385297664 0.7061192080053049 -2.516578301477168e-07 -0.09944206688935138 -1.935 0.7061206822736414 0.7061195094298067 -2.5056101677148335e-07 -0.09944223590635598 -1.9351 0.7061209791714601 0.706119810751445 -2.4941677779707905e-07 -0.09944240487230271 -1.9352 0.7061212759916524 0.7061201119697412 -2.482253907143406e-07 -0.09944257378720685 -1.9353000000000002 0.7061215727347478 0.7061204130842208 -2.469871438239013e-07 -0.09944274265108381 -1.9354 0.706121869401273 0.7061207140944119 -2.4570233604290226e-07 -0.09944291146394893 -1.9355 0.7061221659917506 0.706121014999846 -2.4437127699172834e-07 -0.09944308022581749 -1.9356000000000002 0.7061224625067002 0.7061213158000579 -2.4299428679278035e-07 -0.09944324893670478 -1.9357 0.7061227589466377 0.7061216164945862 -2.4157169606700557e-07 -0.09944341759662619 -1.9358000000000002 0.7061230553120752 0.7061219170829733 -2.4010384582287547e-07 -0.09944358620559697 -1.9359000000000002 0.7061233516035215 0.7061222175647651 -2.3859108736618007e-07 -0.09944375476363249 -1.936 0.7061236478214805 0.7061225179395112 -2.3703378225839455e-07 -0.09944392327074791 -1.9361000000000002 0.7061239439664531 0.7061228182067659 -2.3543230220218758e-07 -0.09944409172695869 -1.9362000000000001 0.7061242400389357 0.7061231183660869 -2.3378702893733783e-07 -0.09944426013228001 -1.9363000000000001 0.7061245360394204 0.7061234184170364 -2.3209835416093672e-07 -0.0994444284867272 -1.9364000000000001 0.7061248319683953 0.7061237183591812 -2.303666794892245e-07 -0.09944459679031561 -1.9365 0.7061251278263436 0.7061240181920918 -2.285924162494235e-07 -0.09944476504306043 -1.9366 0.7061254236137441 0.7061243179153437 -2.2677598550055467e-07 -0.09944493324497694 -1.9367 0.706125719331071 0.7061246175285172 -2.2491781785302645e-07 -0.09944510139608043 -1.9368 0.706126014978794 0.7061249170311967 -2.2301835339577636e-07 -0.09944526949638616 -1.9369 0.7061263105573776 0.7061252164229722 -2.2107804160606537e-07 -0.09944543754590938 -1.937 0.7061266060672815 0.7061255157034381 -2.1909734119682223e-07 -0.09944560554466533 -1.9371 0.7061269015089605 0.706125814872194 -2.1707672005419343e-07 -0.09944577349266936 -1.9372 0.7061271968828637 0.7061261139288444 -2.15016655119582e-07 -0.09944594138993657 -1.9373000000000002 0.7061274921894358 0.7061264128729996 -2.1291763226821692e-07 -0.09944610923648231 -1.9374 0.7061277874291155 0.7061267117042744 -2.107801461842529e-07 -0.09944627703232178 -1.9375 0.7061280826023362 0.70612701042229 -2.0860470027056488e-07 -0.09944644477747018 -1.9376000000000002 0.7061283777095262 0.7061273090266722 -2.063918064995618e-07 -0.09944661247194284 -1.9377 0.7061286727511078 0.7061276075170525 -2.041419853021642e-07 -0.09944678011575485 -1.9378000000000002 0.7061289677274976 0.7061279058930685 -2.018557654880071e-07 -0.09944694770892148 -1.9379000000000002 0.7061292626391067 0.7061282041543634 -1.995336840511508e-07 -0.09944711525145798 -1.938 0.70612955748634 0.7061285023005862 -1.9717628607987536e-07 -0.09944728274337955 -1.9381000000000002 0.7061298522695968 0.706128800331392 -1.94784124666475e-07 -0.0994474501847014 -1.9382000000000001 0.70613014698927 0.7061290982464417 -1.9235776067827448e-07 -0.0994476175754387 -1.9383000000000001 0.7061304416457468 0.7061293960454023 -1.8989776274028203e-07 -0.0994477849156067 -1.9384000000000001 0.7061307362394075 0.706129693727947 -1.874047070131446e-07 -0.09944795220522051 -1.9385 0.7061310307706269 0.7061299912937555 -1.8487917710988122e-07 -0.09944811944429541 -1.9386 0.706131325239773 0.7061302887425136 -1.823217639362884e-07 -0.09944828663284651 -1.9387 0.7061316196472074 0.7061305860739135 -1.7973306555910118e-07 -0.099448453770889 -1.9388 0.7061319139932853 0.7061308832876545 -1.7711368707068464e-07 -0.09944862085843813 -1.9389 0.7061322082783554 0.706131180383441 -1.7446424043637832e-07 -0.09944878789550894 -1.939 0.7061325025027594 0.7061314773609857 -1.7178534436265713e-07 -0.09944895488211665 -1.9391 0.7061327966668327 0.7061317742200073 -1.6907762414621053e-07 -0.0994491218182765 -1.9392 0.7061330907709036 0.706132070960231 -1.6634171153516453e-07 -0.09944928870400353 -1.9393000000000002 0.7061333848152935 0.7061323675813894 -1.635782445746914e-07 -0.09944945553931295 -1.9394 0.7061336788003172 0.7061326640832217 -1.607878674595581e-07 -0.09944962232421993 -1.9395 0.7061339727262822 0.706132960465474 -1.5797123039534844e-07 -0.09944978905873955 -1.9396000000000002 0.7061342665934891 0.7061332567278997 -1.5512898942672548e-07 -0.09944995574288698 -1.9397 0.7061345604022313 0.706133552870259 -1.5226180628651054e-07 -0.09945012237667739 -1.9398000000000002 0.706134854152795 0.7061338488923197 -1.4937034826904838e-07 -0.09945028896012582 -1.9399000000000002 0.7061351478454594 0.7061341447938563 -1.4645528804632657e-07 -0.09945045549324748 -1.94 0.7061354414804961 0.7061344405746508 -1.4351730350664615e-07 -0.09945062197605746 -1.9401000000000002 0.7061357350581695 0.7061347362344925 -1.4055707764706882e-07 -0.09945078840857083 -1.9402000000000001 0.7061360285787368 0.7061350317731785 -1.3757529834790283e-07 -0.09945095479080278 -1.9403000000000001 0.7061363220424473 0.7061353271905128 -1.3457265825994602e-07 -0.09945112112276838 -1.9404000000000001 0.706136615449543 0.7061356224863067 -1.3154985462580926e-07 -0.09945128740448271 -1.9405 0.7061369088002585 0.7061359176603798 -1.2850758911511773e-07 -0.09945145363596092 -1.9406 0.7061372020948209 0.7061362127125586 -1.2544656767185525e-07 -0.09945161981721805 -1.9407 0.7061374953334493 0.7061365076426773 -1.2236750034609611e-07 -0.0994517859482692 -1.9408 0.7061377885163553 0.7061368024505785 -1.1927110111879802e-07 -0.09945195202912949 -1.9409 0.706138081643743 0.7061370971361113 -1.1615808777169778e-07 -0.09945211805981398 -1.941 0.7061383747158083 0.7061373916991333 -1.1302918166700149e-07 -0.09945228404033771 -1.9411 0.7061386677327399 0.7061376861395099 -1.0988510762074966e-07 -0.09945244997071581 -1.9412 0.7061389606947179 0.706137980457114 -1.0672659373281435e-07 -0.09945261585096331 -1.9413000000000002 0.7061392536019153 0.7061382746518262 -1.035543711908754e-07 -0.09945278168109523 -1.9414 0.7061395464544966 0.7061385687235359 -1.0036917413337731e-07 -0.09945294746112672 -1.9415 0.7061398392526191 0.7061388626721392 -9.717173946478114e-08 -0.0994531131910728 -1.9416000000000002 0.7061401319964313 0.7061391564975408 -9.3962806676888e-08 -0.09945327887094849 -1.9417 0.7061404246860745 0.7061394501996532 -9.07431176944487e-08 -0.09945344450076886 -1.9418000000000002 0.7061407173216816 0.7061397437783969 -8.75134166990893e-08 -0.09945361008054894 -1.9419000000000002 0.7061410099033774 0.7061400372337007 -8.427444994456301e-08 -0.09945377561030377 -1.942 0.7061413024312786 0.7061403305655007 -8.102696560235989e-08 -0.09945394109004838 -1.9421000000000002 0.7061415949054946 0.7061406237737419 -7.777171357782608e-08 -0.09945410651979777 -1.9422000000000001 0.7061418873261256 0.7061409168583763 -7.450944534016096e-08 -0.09945427189956697 -1.9423000000000001 0.7061421796932646 0.7061412098193653 -7.124091375154684e-08 -0.09945443722937103 -1.9424000000000001 0.7061424720069962 0.7061415026566775 -6.796687288760511e-08 -0.09945460250922498 -1.9425 0.7061427642673966 0.7061417953702895 -6.468807786782702e-08 -0.09945476773914373 -1.9426 0.7061430564745346 0.7061420879601864 -6.140528468123393e-08 -0.09945493291914237 -1.9427 0.7061433486284701 0.7061423804263615 -5.811925001377241e-08 -0.0994550980492359 -1.9428 0.7061436407292554 0.7061426727688156 -5.483073106985446e-08 -0.09945526312943925 -1.9429 0.7061439327769343 0.7061429649875586 -5.154048539671684e-08 -0.09945542815976749 -1.943 0.7061442247715426 0.7061432570826073 -4.824927071767071e-08 -0.09945559314023551 -1.9431 0.7061445167131082 0.7061435490539878 -4.4957844750280994e-08 -0.09945575807085838 -1.9432 0.7061448086016505 0.7061438409017335 -4.166696503498106e-08 -0.09945592295165108 -1.9433000000000002 0.7061451004371809 0.7061441326258864 -3.83773887615191e-08 -0.09945608778262854 -1.9434 0.7061453922197027 0.7061444242264963 -3.508987259353419e-08 -0.09945625256380569 -1.9435 0.7061456839492111 0.7061447157036214 -3.1805172494379225e-08 -0.09945641729519757 -1.9436000000000002 0.7061459756256931 0.7061450070573274 -2.852404355400094e-08 -0.09945658197681911 -1.9437 0.7061462672491278 0.706145298287689 -2.524723981441046e-08 -0.09945674660868525 -1.9438000000000002 0.706146558819486 0.7061455893947883 -2.1975514098541982e-08 -0.09945691119081097 -1.9439000000000002 0.7061468503367307 0.7061458803787152 -1.870961783504571e-08 -0.09945707572321119 -1.944 0.7061471418008163 0.7061461712395684 -1.5450300889802843e-08 -0.09945724020590085 -1.9441000000000002 0.7061474332116899 0.7061464619774543 -1.2198311385731159e-08 -0.09945740463889492 -1.9442000000000002 0.7061477245692902 0.7061467525924872 -8.954395540588383e-09 -0.09945756902220831 -1.9443000000000001 0.7061480158735478 0.7061470430847894 -5.719297491331432e-09 -0.09945773335585593 -1.9444000000000001 0.7061483071243856 0.706147333454491 -2.493759118475658e-09 -0.09945789763985274 -1.9445 0.7061485983217183 0.7061476237017306 7.214801126323445e-10 -0.09945806187421363 -1.9446 0.7061488894654526 0.7061479138266538 3.92568333135862e-09 -0.09945822605895349 -1.9447 0.7061491805554883 0.7061482038294149 7.118116420942733e-09 -0.09945839019408732 -1.9448 0.7061494715917158 0.7061484937101756 1.0298048198909004e-08 -0.09945855427962996 -1.9449 0.706149762574019 0.7061487834691056 1.3464750580997886e-08 -0.0994587183155963 -1.945 0.7061500535022733 0.706149073106382 1.66174987320869e-08 -0.09945888230200128 -1.9451 0.7061503443763466 0.70614936262219 1.9755571257010218e-08 -0.09945904623885977 -1.9452 0.706150635196099 0.7061496520167222 2.287825035061225e-08 -0.09945921012618664 -1.9453000000000003 0.7061509259613832 0.7061499412901794 2.598482195387275e-08 -0.0994593739639968 -1.9454 0.7061512166720438 0.7061502304427694 2.907457593952223e-08 -0.09945953775230515 -1.9455 0.7061515073279184 0.7061505194747075 3.2146806265564987e-08 -0.09945970149112651 -1.9456000000000002 0.7061517979288365 0.7061508083862172 3.520081111839379e-08 -0.09945986518047578 -1.9457 0.7061520884746206 0.7061510971775291 3.823589310447684e-08 -0.09946002882036784 -1.9458000000000002 0.7061523789650854 0.7061513858488807 4.1251359382196706e-08 -0.09946019241081752 -1.9459000000000002 0.7061526694000386 0.7061516744005178 4.424652183705746e-08 -0.09946035595183973 -1.946 0.7061529597792803 0.7061519628326929 4.722069722219724e-08 -0.09946051944344926 -1.9461000000000002 0.7061532501026031 0.7061522511456657 5.0173207344003656e-08 -0.09946068288566101 -1.9462000000000002 0.7061535403697927 0.7061525393397039 5.310337917834029e-08 -0.09946084627848979 -1.9463000000000001 0.7061538305806276 0.7061528274150812 5.601054505789682e-08 -0.09946100962195045 -1.9464000000000001 0.7061541207348796 0.706153115372079 5.889404279361965e-08 -0.09946117291605781 -1.9465 0.7061544108323123 0.7061534032109859 6.175321585685789e-08 -0.0994613361608267 -1.9466 0.7061547008726838 0.7061536909320972 6.458741349905928e-08 -0.099461499356272 -1.9467 0.7061549908557443 0.7061539785357152 6.739599092003834e-08 -0.09946166250240848 -1.9468 0.7061552807812369 0.7061542660221488 7.017830941369319e-08 -0.09946182559925096 -1.9469 0.7061555706488991 0.7061545533917142 7.29337365015792e-08 -0.09946198864681428 -1.947 0.7061558604584606 0.7061548406447336 7.566164607689108e-08 -0.09946215164511327 -1.9471 0.706156150209645 0.7061551277815361 7.836141856752687e-08 -0.09946231459416262 -1.9472 0.7061564399021691 0.7061554148024578 8.103244105231444e-08 -0.09946247749397731 -1.9473000000000003 0.7061567295357432 0.706155701707841 8.36741074067282e-08 -0.09946264034457197 -1.9474 0.7061570191100713 0.7061559884980337 8.628581845901429e-08 -0.09946280314596147 -1.9475 0.7061573086248512 0.7061562751733916 8.886698207519195e-08 -0.09946296589816059 -1.9476000000000002 0.7061575980797739 0.7061565617342755 9.141701337242458e-08 -0.09946312860118411 -1.9477 0.7061578874745247 0.7061568481810528 9.393533477800031e-08 -0.0994632912550468 -1.9478000000000002 0.7061581768087826 0.7061571345140971 9.642137620280433e-08 -0.09946345385976342 -1.9479000000000002 0.7061584660822207 0.706157420733788 9.887457515581066e-08 -0.09946361641534879 -1.948 0.7061587552945057 0.7061577068405105 1.0129437686204334e-07 -0.09946377892181756 -1.9481000000000002 0.7061590444452992 0.7061579928346565 1.0368023440829321e-07 -0.09946394137918464 -1.9482000000000002 0.7061593335342564 0.706158278716623 1.0603160885067076e-07 -0.09946410378746473 -1.9483000000000001 0.7061596225610272 0.7061585644868122 1.0834796934297564e-07 -0.09946426614667256 -1.9484000000000001 0.7061599115252553 0.7061588501456327 1.1062879326506625e-07 -0.09946442845682285 -1.9485 0.7061602004265795 0.7061591356934984 1.1287356632000423e-07 -0.09946459071793042 -1.9486 0.7061604892646332 0.7061594211308285 1.1508178266589342e-07 -0.09946475293000995 -1.9487 0.7061607780390438 0.7061597064580474 1.1725294502343275e-07 -0.09946491509307616 -1.9488 0.7061610667494345 0.706159991675585 1.193865647834691e-07 -0.09946507720714388 -1.9489 0.7061613553954222 0.7061602767838759 1.2148216214577512e-07 -0.09946523927222772 -1.949 0.7061616439766198 0.7061605617833603 1.2353926619537714e-07 -0.09946540128834247 -1.9491 0.7061619324926344 0.7061608466744829 1.2555741499276074e-07 -0.09946556325550278 -1.9492 0.7061622209430687 0.7061611314576934 1.2753615571264865e-07 -0.09946572517372347 -1.9493000000000003 0.7061625093275206 0.7061614161334462 1.2947504475502303e-07 -0.0994658870430191 -1.9494 0.7061627976455833 0.7061617007022005 1.31373647811045e-07 -0.09946604886340454 -1.9495 0.7061630858968457 0.7061619851644199 1.332315399601991e-07 -0.09946621063489437 -1.9496000000000002 0.7061633740808915 0.7061622695205722 1.3504830579519345e-07 -0.09946637235750332 -1.9497 0.7061636621973009 0.7061625537711297 1.3682353950869586e-07 -0.09946653403124607 -1.9498000000000002 0.7061639502456496 0.7061628379165692 1.3855684493149778e-07 -0.09946669565613733 -1.9499000000000002 0.7061642382255091 0.7061631219573713 1.402478357094561e-07 -0.09946685723219177 -1.95 0.7061645261364466 0.7061634058940208 1.4189613531390144e-07 -0.09946701875942407 -1.9501000000000002 0.7061648139780259 0.7061636897270065 1.4350137715612998e-07 -0.09946718023784895 -1.9502000000000002 0.7061651017498064 0.7061639734568204 1.4506320467760903e-07 -0.09946734166748095 -1.9503000000000001 0.7061653894513442 0.7061642570839588 1.4658127141242705e-07 -0.09946750304833482 -1.9504000000000001 0.7061656770821918 0.7061645406089214 1.48055241067091e-07 -0.0994676643804252 -1.9505 0.7061659646418981 0.7061648240322114 1.4948478758991524e-07 -0.09946782566376679 -1.9506000000000001 0.7061662521300087 0.7061651073543354 1.508695952751049e-07 -0.09946798689837419 -1.9507 0.706166539546066 0.7061653905758032 1.5220935878704211e-07 -0.09946814808426212 -1.9508 0.7061668268896089 0.7061656736971278 1.5350378326783876e-07 -0.09946830922144517 -1.9509 0.7061671141601731 0.706165956718825 1.5475258434080597e-07 -0.09946847030993793 -1.951 0.7061674013572923 0.7061662396414137 1.559554882561709e-07 -0.09946863134975509 -1.9511 0.7061676884804968 0.7061665224654157 1.5711223189454615e-07 -0.09946879234091127 -1.9512 0.7061679755293139 0.7061668051913552 1.582225628467271e-07 -0.09946895328342109 -1.9513000000000003 0.7061682625032688 0.7061670878197591 1.5928623944838627e-07 -0.0994691141772992 -1.9514 0.7061685494018843 0.7061673703511571 1.6030303083211517e-07 -0.09946927502256017 -1.9515 0.7061688362246803 0.7061676527860805 1.6127271703150758e-07 -0.09946943581921865 -1.9516000000000002 0.7061691229711751 0.7061679351250634 1.6219508896034296e-07 -0.09946959656728924 -1.9517 0.7061694096408841 0.7061682173686419 1.630699484889142e-07 -0.09946975726678653 -1.9518000000000002 0.7061696962333217 0.706168499517354 1.638971084648444e-07 -0.0994699179177251 -1.9519000000000002 0.7061699827479996 0.7061687815717395 1.6467639280329238e-07 -0.09947007852011958 -1.952 0.706170269184428 0.7061690635323399 1.654076364661361e-07 -0.09947023907398453 -1.9521000000000002 0.7061705555421159 0.7061693453996989 1.6609068552442263e-07 -0.09947039957933462 -1.9522 0.7061708418205699 0.7061696271743607 1.6672539718612378e-07 -0.09947056003618432 -1.9523000000000001 0.7061711280192959 0.7061699088568718 1.673116398585861e-07 -0.09947072044454826 -1.9524000000000001 0.7061714141377984 0.7061701904477795 1.6784929308261143e-07 -0.099470880804441 -1.9525 0.7061717001755804 0.7061704719476324 1.6833824765735694e-07 -0.09947104111587717 -1.9526000000000001 0.706171986132144 0.7061707533569799 1.687784056403352e-07 -0.09947120137887121 -1.9527 0.7061722720069907 0.7061710346763728 1.691696803196585e-07 -0.09947136159343777 -1.9528 0.7061725577996212 0.7061713159063623 1.6951199625220292e-07 -0.09947152175959141 -1.9529 0.7061728435095347 0.7061715970474999 1.6980528930524152e-07 -0.09947168187734662 -1.953 0.7061731291362308 0.7061718781003383 1.7004950665991392e-07 -0.09947184194671799 -1.9531 0.7061734146792082 0.7061721590654308 1.7024460675918451e-07 -0.09947200196772005 -1.9532 0.7061737001379654 0.7061724399433302 1.7039055941539538e-07 -0.09947216194036734 -1.9533000000000003 0.7061739855120007 0.70617272073459 1.7048734574434676e-07 -0.0994723218646744 -1.9534 0.7061742708008123 0.7061730014397634 1.7053495816182762e-07 -0.09947248174065575 -1.9535 0.7061745560038988 0.7061732820594042 1.7053340043565735e-07 -0.09947264156832597 -1.9536000000000002 0.706174841120758 0.706173562594065 1.7048268763364405e-07 -0.09947280134769947 -1.9537 0.7061751261508891 0.706173843044299 1.70382846127054e-07 -0.09947296107879083 -1.9538000000000002 0.7061754110937911 0.7061741234106589 1.702339135836728e-07 -0.09947312076161463 -1.9539000000000002 0.7061756959489638 0.7061744036936961 1.7003593899209135e-07 -0.0994732803961853 -1.954 0.7061759807159074 0.7061746838939621 1.6978898259578656e-07 -0.09947343998251733 -1.9541000000000002 0.7061762653941231 0.7061749640120071 1.6949311586536564e-07 -0.09947359952062525 -1.9542 0.7061765499831129 0.7061752440483808 1.6914842153673004e-07 -0.09947375901052355 -1.9543000000000001 0.7061768344823799 0.7061755240036316 1.687549935520949e-07 -0.09947391845222674 -1.9544000000000001 0.7061771188914283 0.7061758038783067 1.6831293703917227e-07 -0.09947407784574928 -1.9545 0.7061774032097632 0.7061760836729525 1.6782236830076291e-07 -0.09947423719110567 -1.9546000000000001 0.7061776874368917 0.7061763633881131 1.6728341475577557e-07 -0.09947439648831036 -1.9547 0.706177971572322 0.7061766430243319 1.666962149149409e-07 -0.09947455573737779 -1.9548 0.7061782556155642 0.7061769225821506 1.6606091836346426e-07 -0.09947471493832255 -1.9549 0.70617853956613 0.7061772020621087 1.6537768571592282e-07 -0.09947487409115902 -1.955 0.7061788234235324 0.7061774814647441 1.6464668855728504e-07 -0.09947503319590166 -1.9551 0.7061791071872875 0.706177760790593 1.638681094325023e-07 -0.09947519225256496 -1.9552 0.7061793908569125 0.706178040040189 1.6304214177018106e-07 -0.09947535126116337 -1.9553000000000003 0.7061796744319273 0.7061783192140638 1.621689898617662e-07 -0.09947551022171132 -1.9554 0.7061799579118537 0.7061785983127464 1.6124886877480482e-07 -0.09947566913422323 -1.9555 0.7061802412962166 0.7061788773367639 1.6028200434947681e-07 -0.09947582799871357 -1.9556000000000002 0.7061805245845427 0.7061791562866404 1.5926863308757255e-07 -0.09947598681519679 -1.9557 0.7061808077763618 0.7061794351628977 1.582090021524929e-07 -0.0994761455836873 -1.9558000000000002 0.7061810908712065 0.7061797139660544 1.5710336925475743e-07 -0.09947630430419953 -1.9559000000000002 0.7061813738686122 0.7061799926966263 1.559520026311878e-07 -0.09947646297674789 -1.956 0.7061816567681173 0.7061802713551264 1.5475518098939656e-07 -0.09947662160134685 -1.9561000000000002 0.706181939569263 0.7061805499420643 1.535131933724787e-07 -0.09947678017801069 -1.9562 0.7061822222715941 0.7061808284579467 1.5222633914513395e-07 -0.09947693870675395 -1.9563000000000001 0.7061825048746591 0.7061811069032767 1.5089492792427772e-07 -0.09947709718759101 -1.9564000000000001 0.7061827873780087 0.7061813852785539 1.4951927946454946e-07 -0.09947725562053622 -1.9565 0.7061830697811984 0.7061816635842746 1.4809972363402646e-07 -0.099477414005604 -1.9566000000000001 0.706183352083787 0.7061819418209312 1.4663660028585435e-07 -0.0994775723428088 -1.9567 0.7061836342853365 0.7061822199890124 1.451302592166137e-07 -0.09947773063216492 -1.9568 0.7061839163854137 0.7061824980890029 1.4358106007264504e-07 -0.0994778888736868 -1.9569 0.7061841983835884 0.7061827761213839 1.4198937222167918e-07 -0.0994780470673888 -1.957 0.7061844802794354 0.7061830540866316 1.403555747285512e-07 -0.0994782052132853 -1.9571 0.706184762072533 0.7061833319852191 1.3868005623030033e-07 -0.09947836331139069 -1.9572 0.7061850437624638 0.7061836098176142 1.369632148529032e-07 -0.09947852136171925 -1.9573000000000003 0.7061853253488153 0.7061838875842812 1.3520545811065987e-07 -0.09947867936428548 -1.9574 0.7061856068311794 0.7061841652856791 1.3340720280557994e-07 -0.09947883731910367 -1.9575 0.7061858882091516 0.7061844429222628 1.3156887494064629e-07 -0.09947899522618814 -1.9576000000000002 0.7061861694823331 0.7061847204944824 1.2969090964695673e-07 -0.09947915308555325 -1.9577 0.7061864506503301 0.7061849980027833 1.2777375100331279e-07 -0.09947931089721342 -1.9578000000000002 0.7061867317127526 0.7061852754476059 1.2581785199458628e-07 -0.0994794686611829 -1.9579000000000002 0.7061870126692162 0.7061855528293854 1.2382367439028874e-07 -0.09947962637747607 -1.958 0.7061872935193416 0.7061858301485521 1.2179168863354906e-07 -0.0994797840461072 -1.9581000000000002 0.7061875742627546 0.7061861074055316 1.1972237371968286e-07 -0.09947994166709073 -1.9582 0.7061878548990859 0.7061863846007437 1.1761621710598691e-07 -0.09948009924044093 -1.9583000000000002 0.706188135427972 0.7061866617346029 1.1547371457643063e-07 -0.09948025676617206 -1.9584000000000001 0.7061884158490543 0.7061869388075184 1.132953701271644e-07 -0.09948041424429852 -1.9585 0.7061886961619803 0.7061872158198941 1.1108169584855832e-07 -0.09948057167483458 -1.9586000000000001 0.7061889763664027 0.7061874927721279 1.0883321183152717e-07 -0.09948072905779459 -1.9587 0.7061892564619798 0.7061877696646122 1.0655044601140529e-07 -0.0994808863931928 -1.9588 0.7061895364483761 0.7061880464977337 1.0423393406039372e-07 -0.09948104368104357 -1.9589 0.7061898163252613 0.7061883232718732 1.0188421925919067e-07 -0.09948120092136112 -1.959 0.7061900960923115 0.7061885999874052 9.950185235821363e-08 -0.09948135811415976 -1.9591 0.7061903757492085 0.7061888766446989 9.708739146310763e-08 -0.09948151525945378 -1.9592 0.7061906552956405 0.7061891532441169 9.464140189943682e-08 -0.09948167235725751 -1.9593000000000003 0.7061909347313016 0.7061894297860158 9.21644560843149e-08 -0.09948182940758513 -1.9594 0.7061912140558919 0.7061897062707461 8.965713339456616e-08 -0.09948198641045096 -1.9595 0.7061914932691183 0.7061899826986516 8.712002001753927e-08 -0.0994821433658693 -1.9596000000000002 0.7061917723706939 0.7061902590700704 8.455370881059465e-08 -0.0994823002738544 -1.9597 0.7061920513603379 0.7061905353853332 8.195879919875582e-08 -0.09948245713442047 -1.9598000000000002 0.7061923302377766 0.7061908116447648 7.933589699950228e-08 -0.09948261394758184 -1.9599000000000002 0.7061926090027426 0.7061910878486839 7.668561428225695e-08 -0.09948277071335278 -1.96 0.7061928876549746 0.7061913639974011 7.400856925562915e-08 -0.09948292743174743 -1.9601000000000002 0.7061931661942189 0.7061916400912216 7.130538609394221e-08 -0.09948308410278009 -1.9602 0.7061934446202277 0.7061919161304434 6.857669479845563e-08 -0.09948324072646497 -1.9603000000000002 0.7061937229327607 0.7061921921153578 6.582313105164828e-08 -0.09948339730281637 -1.9604000000000001 0.7061940011315844 0.7061924680462486 6.304533608364471e-08 -0.0994835538318485 -1.9605 0.7061942792164716 0.7061927439233934 6.024395650047754e-08 -0.0994837103135755 -1.9606000000000001 0.7061945571872029 0.7061930197470623 5.7419644140105364e-08 -0.09948386674801168 -1.9607 0.7061948350435656 0.7061932955175187 5.457305593536965e-08 -0.09948402313517125 -1.9608 0.7061951127853541 0.7061935712350188 5.170485373878764e-08 -0.09948417947506843 -1.9609 0.7061953904123699 0.7061938468998112 4.881570419071335e-08 -0.0994843357677174 -1.961 0.7061956679244217 0.7061941225121378 4.590627854239582e-08 -0.09948449201313232 -1.9611 0.706195945321326 0.706194398072233 4.2977252524140086e-08 -0.09948464821132752 -1.9612 0.7061962226029054 0.7061946735803242 4.002930616489597e-08 -0.0994848043623171 -1.9613000000000003 0.7061964997689909 0.7061949490366306 3.706312365694964e-08 -0.09948496046611525 -1.9614 0.7061967768194205 0.7061952244413651 3.407939317377762e-08 -0.09948511652273619 -1.9615 0.7061970537540398 0.7061954997947324 3.10788067277995e-08 -0.09948527253219411 -1.9616000000000002 0.7061973305727016 0.7061957750969303 2.8062060007313927e-08 -0.09948542849450319 -1.9617 0.7061976072752663 0.7061960503481483 2.5029852203026226e-08 -0.09948558440967756 -1.9618000000000002 0.706197883861602 0.7061963255485689 2.1982885871005275e-08 -0.09948574027773142 -1.9619000000000002 0.7061981603315839 0.7061966006983673 1.892186673492502e-08 -0.09948589609867897 -1.962 0.7061984366850955 0.7061968757977103 1.5847503564633825e-08 -0.09948605187253429 -1.9621000000000002 0.7061987129220272 0.7061971508467575 1.276050797492656e-08 -0.0994862075993116 -1.9622 0.7061989890422777 0.7061974258456611 9.661594277225738e-09 -0.09948636327902506 -1.9623000000000002 0.7061992650457534 0.706197700794565 6.551479311313335e-09 -0.09948651891168885 -1.9624000000000001 0.7061995409323676 0.7061979756936059 3.4308822918077686e-09 -0.09948667449731703 -1.9625 0.706199816702042 0.7061982505429119 3.0052462254848145e-10 -0.09948683003592378 -1.9626000000000001 0.706200092354706 0.7061985253426046 -2.8388702621312545e-09 -0.09948698552752328 -1.9627000000000001 0.7062003678902964 0.7061988000927969 -5.986577063070431e-09 -0.09948714097212957 -1.9628 0.7062006433087584 0.7061990747935939 -9.141868781946394e-09 -0.09948729636975684 -1.9629 0.7062009186100446 0.7061993494450932 -1.2304016892145109e-08 -0.09948745172041919 -1.963 0.7062011937941157 0.7061996240473849 -1.547229150919774e-08 -0.09948760702413077 -1.9631 0.7062014688609399 0.70619989860055 -1.864596155297729e-08 -0.0994877622809057 -1.9632 0.7062017438104934 0.7062001731046631 -2.1824294919002563e-08 -0.09948791749075805 -1.9633000000000003 0.7062020186427603 0.7062004475597898 -2.5006558652777844e-08 -0.09948807265370195 -1.9634 0.7062022933577327 0.7062007219659887 -2.819201911285693e-08 -0.09948822776975152 -1.9635 0.70620256795541 0.7062009963233098 -3.1379942136726055e-08 -0.09948838283892085 -1.9636000000000002 0.7062028424358004 0.7062012706317956 -3.4569593217312e-08 -0.09948853786122402 -1.9637 0.7062031167989191 0.7062015448914807 -3.7760237670382904e-08 -0.0994886928366751 -1.9638000000000002 0.7062033910447896 0.7062018191023918 -4.095114080146121e-08 -0.09948884776528827 -1.9639000000000002 0.7062036651734434 0.7062020932645475 -4.4141568075148916e-08 -0.09948900264707755 -1.964 0.7062039391849193 0.7062023673779585 -4.733078528494075e-08 -0.099489157482057 -1.9641000000000002 0.7062042130792646 0.7062026414426279 -5.0518058722142864e-08 -0.0994893122702407 -1.9642 0.7062044868565341 0.7062029154585511 -5.370265534652627e-08 -0.09948946701164274 -1.9643000000000002 0.7062047605167907 0.706203189425715 -5.688384295001424e-08 -0.0994896217062772 -1.9644000000000001 0.7062050340601049 0.706203463344099 -6.00608903297481e-08 -0.09948977635415812 -1.9645 0.7062053074865551 0.7062037372136749 -6.323306745359067e-08 -0.09948993095529957 -1.9646000000000001 0.7062055807962277 0.7062040110344063 -6.639964562774395e-08 -0.09949008550971562 -1.9647000000000001 0.7062058539892163 0.706204284806249 -6.955989766610146e-08 -0.09949024001742028 -1.9648 0.706206127065623 0.706204558529151 -7.271309805613121e-08 -0.09949039447842757 -1.9649 0.706206400025557 0.706204832203053 -7.58585231241081e-08 -0.09949054889275158 -1.965 0.7062066728691361 0.7062051058278875 -7.899545120034629e-08 -0.09949070326040638 -1.9651 0.7062069455964848 0.7062053794035794 -8.212316279006954e-08 -0.09949085758140595 -1.9652 0.7062072182077359 0.7062056529300459 -8.524094073387306e-08 -0.0994910118557643 -1.9653000000000003 0.7062074907030299 0.7062059264071963 -8.83480703699202e-08 -0.09949116608349545 -1.9654 0.7062077630825145 0.7062061998349327 -9.144383970611375e-08 -0.09949132026461352 -1.9655 0.7062080353463456 0.7062064732131497 -9.452753957014948e-08 -0.09949147439913246 -1.9656000000000002 0.7062083074946859 0.7062067465417333 -9.759846378645798e-08 -0.09949162848706627 -1.9657 0.7062085795277062 0.7062070198205629 -1.0065590933319712e-07 -0.09949178252842894 -1.9658000000000002 0.7062088514455849 0.7062072930495102 -1.0369917649057092e-07 -0.09949193652323456 -1.9659 0.706209123248507 0.7062075662284395 -1.0672756901950603e-07 -0.09949209047149704 -1.966 0.706209394936666 0.7062078393572073 -1.0974039431344007e-07 -0.09949224437323043 -1.9661000000000002 0.706209666510262 0.706208112435663 -1.1273696355271201e-07 -0.09949239822844864 -1.9662 0.7062099379695027 0.7062083854636487 -1.1571659185721783e-07 -0.09949255203716575 -1.9663000000000002 0.7062102093146034 0.706208658440999 -1.186785984728933e-07 -0.09949270579939572 -1.9664000000000001 0.7062104805457861 0.706208931367541 -1.2162230688186892e-07 -0.09949285951515248 -1.9665 0.7062107516632804 0.7062092042430954 -1.2454704499502423e-07 -0.09949301318445004 -1.9666000000000001 0.7062110226673228 0.7062094770674749 -1.2745214527688786e-07 -0.0994931668073024 -1.9667000000000001 0.7062112935581573 0.7062097498404858 -1.3033694493125303e-07 -0.0994933203837235 -1.9668 0.706211564336034 0.7062100225619268 -1.3320078601740393e-07 -0.09949347391372729 -1.9669 0.706211835001211 0.7062102952315894 -1.360430156218534e-07 -0.09949362739732766 -1.967 0.7062121055539531 0.706210567849259 -1.3886298599018188e-07 -0.09949378083453869 -1.9671 0.7062123759945317 0.7062108404147134 -1.4166005469877507e-07 -0.09949393422537428 -1.9672 0.7062126463232252 0.7062111129277239 -1.4443358478145873e-07 -0.09949408756984837 -1.9673000000000003 0.7062129165403188 0.7062113853880547 -1.4718294488215433e-07 -0.09949424086797491 -1.9674 0.7062131866461042 0.7062116577954638 -1.4990750938845276e-07 -0.09949439411976783 -1.9675 0.7062134566408799 0.7062119301497023 -1.5260665859814782e-07 -0.09949454732524106 -1.9676000000000002 0.7062137265249508 0.7062122024505144 -1.552797788337279e-07 -0.09949470048440856 -1.9677 0.7062139962986287 0.7062124746976381 -1.579262625846234e-07 -0.09949485359728419 -1.9678000000000002 0.706214265962231 0.7062127468908053 -1.6054550867027062e-07 -0.09949500666388193 -1.9679 0.7062145355160827 0.7062130190297407 -1.6313692234766475e-07 -0.09949515968421568 -1.968 0.7062148049605141 0.7062132911141632 -1.6569991546575014e-07 -0.09949531265829936 -1.9681000000000002 0.7062150742958619 0.7062135631437857 -1.68233906586851e-07 -0.09949546558614684 -1.9682 0.7062153435224692 0.7062138351183141 -1.7073832112197984e-07 -0.09949561846777204 -1.9683000000000002 0.7062156126406851 0.7062141070374494 -1.7321259145920698e-07 -0.09949577130318893 -1.9684000000000001 0.7062158816508644 0.7062143789008855 -1.7565615709896898e-07 -0.09949592409241129 -1.9685 0.7062161505533682 0.7062146507083108 -1.7806846477549931e-07 -0.09949607683545306 -1.9686000000000001 0.7062164193485632 0.706214922459408 -1.804489685938715e-07 -0.09949622953232812 -1.9687000000000001 0.7062166880368224 0.7062151941538538 -1.8279713011673526e-07 -0.0994963821830504 -1.9688 0.7062169566185235 0.7062154657913196 -1.8511241853258475e-07 -0.09949653478763375 -1.9689 0.7062172250940506 0.7062157373714704 -1.8739431075984192e-07 -0.09949668734609204 -1.969 0.7062174934637926 0.7062160088939662 -1.8964229155093992e-07 -0.09949683985843907 -1.9691 0.7062177617281449 0.7062162803584617 -1.918558536137538e-07 -0.0994969923246888 -1.9692 0.7062180298875071 0.7062165517646064 -1.940344977295616e-07 -0.0994971447448551 -1.9693000000000003 0.7062182979422852 0.7062168231120436 -1.961777328848835e-07 -0.09949729711895182 -1.9694 0.7062185658928888 0.7062170944004122 -1.9828507634434e-07 -0.09949744944699274 -1.9695 0.706218833739734 0.706217365629346 -2.0035605378596055e-07 -0.09949760172899175 -1.9696000000000002 0.7062191014832413 0.7062176367984737 -2.0239019939138903e-07 -0.09949775396496274 -1.9697 0.7062193691238361 0.7062179079074191 -2.0438705597425333e-07 -0.09949790615491956 -1.9698000000000002 0.7062196366619484 0.706218178955801 -2.0634617506690156e-07 -0.09949805829887598 -1.9699 0.7062199040980135 0.7062184499432336 -2.0826711700366873e-07 -0.09949821039684585 -1.97 0.7062201714324705 0.7062187208693265 -2.1014945106659355e-07 -0.099498362448843 -1.9701000000000002 0.7062204386657638 0.7062189917336847 -2.1199275552358232e-07 -0.09949851445488124 -1.9702 0.7062207057983416 0.7062192625359094 -2.1379661777412573e-07 -0.09949866641497444 -1.9703000000000002 0.7062209728306565 0.7062195332755963 -2.1556063440827944e-07 -0.09949881832913637 -1.9704000000000002 0.7062212397631658 0.706219803952338 -2.1728441132809473e-07 -0.09949897019738088 -1.9705 0.7062215065963304 0.7062200745657224 -2.1896756378925186e-07 -0.09949912201972178 -1.9706000000000001 0.7062217733306155 0.7062203451153337 -2.2060971652596018e-07 -0.09949927379617288 -1.9707000000000001 0.7062220399664896 0.7062206156007516 -2.2221050381687757e-07 -0.0994994255267479 -1.9708 0.7062223065044257 0.7062208860215526 -2.2376956958225502e-07 -0.09949957721146073 -1.9709 0.7062225729449003 0.7062211563773095 -2.252865674290394e-07 -0.09949972885032514 -1.971 0.7062228392883935 0.7062214266675909 -2.267611607931208e-07 -0.09949988044335491 -1.9711 0.7062231055353887 0.7062216968919622 -2.2819302294280197e-07 -0.0995000319905638 -1.9712 0.7062233716863726 0.7062219670499859 -2.2958183707594282e-07 -0.09950018349196564 -1.9713000000000003 0.7062236377418356 0.7062222371412202 -2.3092729640322718e-07 -0.09950033494757413 -1.9714 0.706223903702271 0.7062225071652215 -2.3222910419673504e-07 -0.0995004863574031 -1.9715 0.706224169568175 0.7062227771215417 -2.3348697390096484e-07 -0.09950063772146633 -1.9716000000000002 0.706224435340047 0.7062230470097306 -2.3470062912242518e-07 -0.09950078903977753 -1.9717 0.7062247010183894 0.7062233168293348 -2.3586980373718758e-07 -0.09950094031235052 -1.9718000000000002 0.7062249666037068 0.7062235865798989 -2.369942419221116e-07 -0.09950109153919906 -1.9719 0.7062252320965067 0.706223856260964 -2.3807369827627545e-07 -0.09950124272033686 -1.972 0.7062254974972992 0.7062241258720685 -2.3910793779322037e-07 -0.09950139385577766 -1.9721000000000002 0.7062257628065964 0.7062243954127492 -2.4009673594421743e-07 -0.0995015449455352 -1.9722 0.7062260280249133 0.7062246648825404 -2.4103987873377863e-07 -0.09950169598962327 -1.9723000000000002 0.7062262931527661 0.7062249342809741 -2.419371627482292e-07 -0.09950184698805555 -1.9724000000000002 0.7062265581906741 0.7062252036075801 -2.4278839517305473e-07 -0.0995019979408458 -1.9725 0.706226823139158 0.7062254728618866 -2.435933938622903e-07 -0.09950214884800773 -1.9726000000000001 0.7062270879987402 0.7062257420434197 -2.443519873697453e-07 -0.09950229970955508 -1.9727000000000001 0.7062273527699454 0.7062260111517039 -2.45064014952473e-07 -0.0995024505255016 -1.9728 0.7062276174532991 0.706226280186262 -2.457293267026095e-07 -0.09950260129586094 -1.9729 0.7062278820493284 0.7062265491466155 -2.463477834398209e-07 -0.09950275202064683 -1.973 0.7062281465585623 0.7062268180322842 -2.469192568500811e-07 -0.09950290269987297 -1.9731 0.7062284109815308 0.7062270868427871 -2.4744362946832466e-07 -0.09950305333355308 -1.9732 0.706228675318765 0.7062273555776417 -2.4792079469232453e-07 -0.0995032039217009 -1.9733000000000003 0.7062289395707966 0.7062276242363649 -2.483506568277949e-07 -0.09950335446433006 -1.9734 0.7062292037381587 0.7062278928184722 -2.487331311022689e-07 -0.09950350496145431 -1.9735 0.706229467821385 0.7062281613234784 -2.4906814366509877e-07 -0.09950365541308726 -1.9736000000000002 0.7062297318210096 0.7062284297508978 -2.4935563162215013e-07 -0.09950380581924258 -1.9737 0.7062299957375678 0.7062286981002444 -2.4959554303233267e-07 -0.09950395617993403 -1.9738000000000002 0.7062302595715946 0.706228966371031 -2.4978783691800843e-07 -0.09950410649517523 -1.9739 0.7062305233236259 0.706229234562771 -2.4993248328927797e-07 -0.0995042567649799 -1.974 0.7062307869941972 0.7062295026749772 -2.50029463133572e-07 -0.09950440698936168 -1.9741000000000002 0.7062310505838443 0.7062297707071623 -2.500787683913652e-07 -0.09950455716833423 -1.9742 0.7062313140931032 0.7062300386588389 -2.5008040200127923e-07 -0.09950470730191122 -1.9743000000000002 0.7062315775225093 0.7062303065295199 -2.5003437788620464e-07 -0.09950485739010625 -1.9744000000000002 0.7062318408725978 0.7062305743187185 -2.4994072091166775e-07 -0.09950500743293297 -1.9745 0.7062321041439037 0.7062308420259484 -2.497994669101167e-07 -0.0995051574304051 -1.9746000000000001 0.7062323673369615 0.7062311096507238 -2.49610662639288e-07 -0.09950530738253625 -1.9747000000000001 0.7062326304523048 0.7062313771925594 -2.4937436583424843e-07 -0.09950545728934007 -1.9748 0.7062328934904667 0.7062316446509703 -2.490906450963726e-07 -0.09950560715083016 -1.9749 0.7062331564519791 0.7062319120254732 -2.487595799696707e-07 -0.09950575696702016 -1.975 0.7062334193373733 0.7062321793155855 -2.4838126084017476e-07 -0.09950590673792371 -1.9751 0.7062336821471793 0.7062324465208253 -2.4795578892553016e-07 -0.09950605646355444 -1.9752 0.7062339448819255 0.7062327136407125 -2.4748327632703737e-07 -0.09950620614392595 -1.9753000000000003 0.7062342075421395 0.7062329806747676 -2.469638459012824e-07 -0.09950635577905181 -1.9754 0.7062344701283474 0.7062332476225135 -2.4639763127054515e-07 -0.09950650536894567 -1.9755 0.7062347326410736 0.7062335144834739 -2.4578477678810495e-07 -0.09950665491362118 -1.9756000000000002 0.7062349950808406 0.7062337812571746 -2.451254375174239e-07 -0.09950680441309188 -1.9757 0.7062352574481693 0.706234047943143 -2.4441977915928836e-07 -0.09950695386737138 -1.9758000000000002 0.7062355197435788 0.7062343145409083 -2.436679780171147e-07 -0.09950710327647327 -1.9759 0.7062357819675857 0.7062345810500019 -2.4287022100735745e-07 -0.09950725264041112 -1.976 0.7062360441207055 0.7062348474699571 -2.420267054999148e-07 -0.09950740195919858 -1.9761000000000002 0.7062363062034501 0.7062351138003099 -2.411376394083342e-07 -0.09950755123284916 -1.9762 0.7062365682163299 0.7062353800405982 -2.402032410336874e-07 -0.09950770046137646 -1.9763000000000002 0.7062368301598527 0.7062356461903623 -2.3922373905416183e-07 -0.09950784964479403 -1.9764000000000002 0.7062370920345235 0.7062359122491457 -2.381993724556719e-07 -0.0995079987831155 -1.9765 0.7062373538408447 0.7062361782164939 -2.3713039049022555e-07 -0.0995081478763544 -1.9766000000000001 0.7062376155793161 0.7062364440919555 -2.3601705259612693e-07 -0.09950829692452427 -1.9767000000000001 0.7062378772504341 0.7062367098750821 -2.3485962837369034e-07 -0.09950844592763869 -1.9768000000000001 0.7062381388546926 0.7062369755654281 -2.3365839744299288e-07 -0.0995085948857112 -1.9769 0.7062384003925821 0.706237241162551 -2.3241364946469112e-07 -0.09950874379875538 -1.977 0.70623866186459 0.706237506666012 -2.3112568400124323e-07 -0.09950889266678475 -1.9771 0.7062389232712001 0.7062377720753749 -2.297948104960923e-07 -0.09950904148981288 -1.9772 0.7062391846128928 0.7062380373902072 -2.2842134816958293e-07 -0.09950919026785324 -1.9773000000000003 0.7062394458901453 0.7062383026100802 -2.270056259565112e-07 -0.09950933900091938 -1.9774 0.7062397071034308 0.7062385677345686 -2.2554798240551066e-07 -0.09950948768902486 -1.9775 0.7062399682532192 0.706238832763251 -2.240487656270107e-07 -0.09950963633218324 -1.9776000000000002 0.7062402293399758 0.7062390976957098 -2.2250833318915308e-07 -0.09950978493040802 -1.9777 0.7062404903641624 0.7062393625315311 -2.209270520622808e-07 -0.09950993348371266 -1.9778000000000002 0.7062407513262363 0.7062396272703053 -2.1930529850444636e-07 -0.09951008199211066 -1.9779 0.7062410122266516 0.7062398919116266 -2.1764345794345052e-07 -0.09951023045561555 -1.978 0.7062412730658575 0.7062401564550942 -2.1594192494561737e-07 -0.09951037887424091 -1.9781000000000002 0.7062415338442987 0.7062404209003111 -2.1420110310477192e-07 -0.09951052724800019 -1.9782 0.7062417945624155 0.7062406852468845 -2.124214049346873e-07 -0.09951067557690683 -1.9783000000000002 0.7062420552206442 0.7062409494944265 -2.106032517580625e-07 -0.09951082386097437 -1.9784000000000002 0.7062423158194158 0.7062412136425538 -2.0874707365101108e-07 -0.09951097210021626 -1.9785 0.7062425763591569 0.706241477690888 -2.0685330928693624e-07 -0.09951112029464611 -1.9786000000000001 0.7062428368402895 0.7062417416390548 -2.049224058810195e-07 -0.09951126844427728 -1.9787000000000001 0.7062430972632299 0.7062420054866856 -2.0295481904797352e-07 -0.09951141654912325 -1.9788000000000001 0.7062433576283903 0.7062422692334162 -2.009510127222447e-07 -0.0995115646091975 -1.9789 0.7062436179361773 0.7062425328788879 -1.9891145904005203e-07 -0.09951171262451353 -1.979 0.7062438781869929 0.7062427964227471 -1.968366382110176e-07 -0.09951186059508484 -1.9791 0.7062441383812327 0.7062430598646451 -1.947270384279609e-07 -0.09951200852092482 -1.9792 0.706244398519288 0.7062433232042387 -1.9258315575240714e-07 -0.09951215640204693 -1.9793000000000003 0.7062446586015445 0.7062435864411902 -1.9040549397927875e-07 -0.09951230423846463 -1.9794 0.7062449186283819 0.7062438495751674 -1.8819456453281203e-07 -0.09951245203019138 -1.9795 0.7062451786001753 0.7062441126058437 -1.8595088633818757e-07 -0.09951259977724071 -1.9796 0.7062454385172927 0.7062443755328979 -1.8367498570703855e-07 -0.09951274747962591 -1.9797 0.7062456983800973 0.7062446383560147 -1.813673962194895e-07 -0.09951289513736043 -1.9798000000000002 0.7062459581889466 0.7062449010748847 -1.7902865857150063e-07 -0.0995130427504578 -1.9799 0.7062462179441917 0.7062451636892042 -1.766593204881317e-07 -0.09951319031893135 -1.98 0.7062464776461782 0.7062454261986757 -1.74259936560478e-07 -0.0995133378427946 -1.9801000000000002 0.7062467372952452 0.7062456886030074 -1.7183106813811744e-07 -0.09951348532206092 -1.9802 0.7062469968917258 0.7062459509019137 -1.6937328319206746e-07 -0.09951363275674367 -1.9803000000000002 0.7062472564359473 0.7062462130951155 -1.668871561812113e-07 -0.09951378014685636 -1.9804000000000002 0.7062475159282302 0.7062464751823394 -1.6437326790484652e-07 -0.09951392749241232 -1.9805 0.7062477753688892 0.7062467371633186 -1.6183220538992793e-07 -0.09951407479342497 -1.9806000000000001 0.7062480347582318 0.7062469990377929 -1.5926456174361614e-07 -0.09951422204990773 -1.9807000000000001 0.7062482940965604 0.7062472608055081 -1.5667093600582604e-07 -0.09951436926187401 -1.9808000000000001 0.7062485533841696 0.7062475224662167 -1.5405193303126563e-07 -0.09951451642933716 -1.9809 0.706248812621348 0.7062477840196777 -1.5140816333157614e-07 -0.09951466355231059 -1.981 0.7062490718083777 0.7062480454656566 -1.4874024292614585e-07 -0.09951481063080768 -1.9811 0.7062493309455341 0.7062483068039258 -1.460487932258836e-07 -0.09951495766484182 -1.9812 0.7062495900330854 0.7062485680342645 -1.4333444086842007e-07 -0.09951510465442641 -1.9813000000000003 0.7062498490712934 0.7062488291564584 -1.405978175671868e-07 -0.09951525159957479 -1.9814 0.7062501080604129 0.7062490901702998 -1.3783955997784259e-07 -0.09951539850030032 -1.9815 0.7062503670006919 0.7062493510755885 -1.3506030956123016e-07 -0.09951554535661636 -1.9816 0.7062506258923714 0.7062496118721311 -1.3226071239255677e-07 -0.09951569216853627 -1.9817 0.7062508847356856 0.7062498725597408 -1.2944141906424955e-07 -0.09951583893607348 -1.9818000000000002 0.7062511435308614 0.706250133138238 -1.266030844864624e-07 -0.09951598565924125 -1.9819 0.7062514022781186 0.7062503936074502 -1.2374636776738002e-07 -0.09951613233805295 -1.982 0.70625166097767 0.7062506539672124 -1.2087193205362334e-07 -0.09951627897252195 -1.9821000000000002 0.7062519196297212 0.7062509142173661 -1.1798044436545085e-07 -0.09951642556266158 -1.9822 0.7062521782344708 0.7062511743577604 -1.1507257544930705e-07 -0.09951657210848518 -1.9823000000000002 0.7062524367921097 0.7062514343882516 -1.1214899963037095e-07 -0.09951671861000608 -1.9824000000000002 0.7062526953028216 0.7062516943087032 -1.092103946338796e-07 -0.0995168650672376 -1.9825 0.7062529537667832 0.7062519541189856 -1.0625744146369742e-07 -0.09951701148019305 -1.9826000000000001 0.7062532121841638 0.7062522138189773 -1.0329082419848618e-07 -0.09951715784888576 -1.9827000000000001 0.7062534705551251 0.706252473408564 -1.0031122987200908e-07 -0.0995173041733291 -1.9828000000000001 0.7062537288798214 0.7062527328876382 -9.731934829705635e-08 -0.09951745045353633 -1.9829 0.7062539871583997 0.7062529922561003 -9.431587191365692e-08 -0.09951759668952068 -1.983 0.7062542453909995 0.7062532515138582 -9.130149561820816e-08 -0.09951774288129556 -1.9831 0.7062545035777525 0.7062535106608273 -8.827691661255493e-08 -0.09951788902887426 -1.9832 0.7062547617187838 0.70625376969693 -8.524283423225198e-08 -0.09951803513227003 -1.9833000000000003 0.7062550198142099 0.7062540286220972 -8.219994979651035e-08 -0.09951818119149625 -1.9834 0.70625527786414 0.7062542874362663 -7.914896644253128e-08 -0.09951832720656616 -1.9835 0.7062555358686764 0.7062545461393828 -7.609058895810539e-08 -0.09951847317749302 -1.9836 0.7062557938279128 0.7062548047313992 -7.302552362635495e-08 -0.09951861910429005 -1.9837 0.7062560517419362 0.7062550632122768 -6.995447805833305e-08 -0.09951876498697065 -1.9838000000000002 0.7062563096108256 0.7062553215819835 -6.687816102562277e-08 -0.09951891082554812 -1.9839 0.7062565674346521 0.7062555798404949 -6.37972823068142e-08 -0.0995190566200356 -1.984 0.7062568252134798 0.7062558379877943 -6.071255251489938e-08 -0.09951920237044638 -1.9841000000000002 0.7062570829473644 0.7062560960238731 -5.7624682941147254e-08 -0.09951934807679381 -1.9842 0.7062573406363546 0.7062563539487297 -5.45343853816313e-08 -0.09951949373909107 -1.9843000000000002 0.7062575982804911 0.7062566117623703 -5.144237198240545e-08 -0.09951963935735139 -1.9844000000000002 0.7062578558798073 0.7062568694648091 -4.8349355069826454e-08 -0.09951978493158813 -1.9845 0.7062581134343284 0.7062571270560676 -4.525604698992934e-08 -0.09951993046181447 -1.9846000000000001 0.7062583709440723 0.7062573845361748 -4.216315994099947e-08 -0.09952007594804362 -1.9847000000000001 0.7062586284090493 0.7062576419051676 -3.9071405812704085e-08 -0.09952022139028882 -1.9848000000000001 0.706258885829262 0.7062578991630905 -3.59814960217272e-08 -0.09952036678856338 -1.9849 0.7062591432047052 0.7062581563099953 -3.289414134632039e-08 -0.09952051214288044 -1.985 0.7062594005353666 0.7062584133459417 -2.981005176256116e-08 -0.09952065745325328 -1.9851 0.7062596578212254 0.7062586702709974 -2.6729936285869657e-08 -0.0995208027196951 -1.9852 0.7062599150622538 0.706258927085237 -2.3654502802686328e-08 -0.0995209479422191 -1.9853000000000003 0.7062601722584163 0.7062591837887426 -2.0584457909901543e-08 -0.09952109312083848 -1.9854 0.7062604294096702 0.7062594403816047 -1.7520506754610532e-08 -0.09952123825556651 -1.9855 0.7062606865159644 0.7062596968639208 -1.4463352870398849e-08 -0.09952138334641639 -1.9856 0.7062609435772411 0.7062599532357954 -1.1413698010592083e-08 -0.09952152839340127 -1.9857 0.7062612005934348 0.7062602094973416 -8.372242000370678e-09 -0.0995216733965344 -1.9858000000000002 0.7062614575644719 0.7062604656486791 -5.3396825598281406e-09 -0.09952181835582892 -1.9859 0.7062617144902719 0.7062607216899357 -2.3167151582542678e-09 -0.09952196327129806 -1.986 0.7062619713707468 0.7062609776212458 6.959671545667123e-10 -0.09952210814295498 -1.9861000000000002 0.7062622282058011 0.7062612334427525 3.697673902312848e-09 -0.09952225297081292 -1.9862 0.7062624849953322 0.7062614891546048 6.687717338249577e-09 -0.09952239775488504 -1.9863000000000002 0.7062627417392295 0.7062617447569599 9.66541261176318e-09 -0.09952254249518445 -1.9864000000000002 0.7062629984373758 0.7062620002499821 1.2630077918414362e-08 -0.09952268719172436 -1.9865 0.7062632550896457 0.7062622556338429 1.5581034657798087e-08 -0.0995228318445179 -1.9866000000000001 0.706263511695908 0.706262510908721 1.8517607586199247e-08 -0.09952297645357827 -1.9867000000000001 0.7062637682560231 0.7062627660748031 2.1439124970115686e-08 -0.09952312101891872 -1.9868000000000001 0.7062640247698445 0.7062630211322818 2.4344918747587485e-08 -0.0995232655405523 -1.9869 0.7062642812372185 0.7062632760813574 2.723432468085263e-08 -0.09952341001849213 -1.987 0.7062645376579846 0.7062635309222371 3.010668249425752e-08 -0.09952355445275142 -1.9871 0.7062647940319752 0.7062637856551357 3.296133603732099e-08 -0.09952369884334328 -1.9872 0.7062650503590153 0.7062640402802742 3.579763343565523e-08 -0.09952384319028085 -1.9873000000000003 0.706265306638924 0.7062642947978809 3.861492722627424e-08 -0.09952398749357727 -1.9874 0.7062655628715119 0.7062645492081913 4.141257452412728e-08 -0.09952413175324569 -1.9875 0.706265819056584 0.706264803511447 4.418993716087671e-08 -0.09952427596929923 -1.9876 0.7062660751939385 0.7062650577078973 4.6946381815002325e-08 -0.09952442014175102 -1.9877 0.7062663312833657 0.7062653117977971 4.9681280185273624e-08 -0.09952456427061412 -1.9878000000000002 0.7062665873246505 0.7062655657814088 5.239400911044578e-08 -0.09952470835590167 -1.9879 0.706266843317571 0.7062658196590015 5.508395071671113e-08 -0.09952485239762691 -1.988 0.7062670992618978 0.7062660734308503 5.775049256862008e-08 -0.09952499639580278 -1.9881000000000002 0.7062673551573957 0.7062663270972374 6.039302779224653e-08 -0.09952514035044245 -1.9882 0.7062676110038232 0.7062665806584506 6.301095523651712e-08 -0.09952528426155904 -1.9883000000000002 0.7062678668009319 0.7062668341147849 6.560367958076407e-08 -0.0995254281291656 -1.9884000000000002 0.7062681225484673 0.7062670874665408 6.817061148564618e-08 -0.09952557195327517 -1.9885 0.7062683782461692 0.7062673407140261 7.071116773366137e-08 -0.09952571573390102 -1.9886000000000001 0.7062686338937703 0.7062675938575538 7.322477135057737e-08 -0.09952585947105609 -1.9887000000000001 0.7062688894909976 0.7062678468974435 7.571085173900538e-08 -0.09952600316475349 -1.9888000000000001 0.706269145037572 0.7062680998340207 7.816884480676967e-08 -0.0995261468150063 -1.9889000000000001 0.7062694005332083 0.706268352667617 8.05981930987465e-08 -0.09952629042182755 -1.989 0.7062696559776158 0.7062686053985698 8.299834592349897e-08 -0.0995264339852304 -1.9891 0.706269911370498 0.7062688580272224 8.536875946256461e-08 -0.09952657750522786 -1.9892 0.7062701667115516 0.7062691105539234 8.770889692831518e-08 -0.09952672098183302 -1.9893000000000003 0.7062704220004692 0.7062693629790275 9.00182286454887e-08 -0.09952686441505891 -1.9894 0.7062706772369362 0.7062696153028951 9.229623220557981e-08 -0.09952700780491855 -1.9895 0.7062709324206335 0.7062698675258917 9.45423925466371e-08 -0.09952715115142502 -1.9896 0.7062711875512366 0.7062701196483885 9.675620210591873e-08 -0.0995272944545914 -1.9897 0.7062714426284152 0.7062703716707619 9.89371609187717e-08 -0.09952743771443068 -1.9898000000000002 0.706271697651834 0.7062706235933938 1.0108477672618466e-07 -0.09952758093095596 -1.9899 0.7062719526211522 0.7062708754166709 1.0319856511356584e-07 -0.09952772410418019 -1.99 0.7062722075360239 0.7062711271409854 1.0527804957319309e-07 -0.09952786723411644 -1.9901000000000002 0.7062724623960985 0.7062713787667343 1.0732276166380839e-07 -0.09952801032077774 -1.9902 0.7062727172010206 0.7062716302943195 1.0933224105225126e-07 -0.09952815336417714 -1.9903000000000002 0.7062729719504293 0.7062718817241478 1.113060356799922e-07 -0.0995282963643276 -1.9904000000000002 0.7062732266439598 0.7062721330566308 1.1324370183946053e-07 -0.09952843932124222 -1.9905 0.7062734812812415 0.7062723842921845 1.1514480426771945e-07 -0.09952858223493391 -1.9906000000000001 0.7062737358619005 0.7062726354312296 1.1700891625054943e-07 -0.09952872510541573 -1.9907000000000001 0.7062739903855573 0.7062728864741912 1.1883561971612333e-07 -0.09952886793270066 -1.9908000000000001 0.7062742448518289 0.7062731374214989 1.2062450533215086e-07 -0.09952901071680167 -1.9909000000000001 0.7062744992603275 0.7062733882735868 1.2237517259608421e-07 -0.09952915345773186 -1.991 0.7062747536106613 0.7062736390308928 1.2408722991144594e-07 -0.09952929615550415 -1.9911 0.706275007902434 0.706273889693859 1.2576029471272898e-07 -0.09952943881013153 -1.9912 0.7062752621352463 0.7062741402629313 1.2739399350009117e-07 -0.09952958142162699 -1.9913000000000003 0.7062755163086936 0.7062743907385598 1.2898796196078588e-07 -0.09952972399000348 -1.9914 0.7062757704223686 0.7062746411211981 1.3054184504895927e-07 -0.09952986651527398 -1.9915 0.7062760244758599 0.706274891411304 1.3205529703075314e-07 -0.09953000899745151 -1.9916 0.7062762784687524 0.7062751416093382 1.3352798159879664e-07 -0.099530151436549 -1.9917 0.7062765324006282 0.7062753917157655 1.3495957191383967e-07 -0.0995302938325795 -1.9918000000000002 0.7062767862710648 0.7062756417310534 1.3634975070883626e-07 -0.09953043618555579 -1.9919 0.7062770400796374 0.7062758916556736 1.3769821035486407e-07 -0.09953057849549102 -1.992 0.7062772938259174 0.7062761414901002 1.3900465290275776e-07 -0.09953072076239804 -1.9921000000000002 0.7062775475094734 0.7062763912348102 1.402687901802535e-07 -0.09953086298628973 -1.9922 0.7062778011298712 0.7062766408902847 1.4149034383362236e-07 -0.09953100516717918 -1.9923000000000002 0.7062780546866733 0.7062768904570064 1.426690453935897e-07 -0.0995311473050792 -1.9924000000000002 0.7062783081794399 0.7062771399354617 1.4380463632043816e-07 -0.09953128940000285 -1.9925 0.7062785616077281 0.7062773893261391 1.4489686811849922e-07 -0.09953143145196301 -1.9926000000000001 0.7062788149710926 0.70627763862953 1.459455023188061e-07 -0.09953157346097258 -1.9927000000000001 0.7062790682690858 0.7062778878461276 1.4695031057276875e-07 -0.09953171542704456 -1.9928000000000001 0.7062793215012576 0.7062781369764277 1.4791107467299058e-07 -0.09953185735019172 -1.9929000000000001 0.706279574667156 0.7062783860209291 1.4882758662612683e-07 -0.09953199923042716 -1.993 0.7062798277663266 0.7062786349801315 1.4969964871186514e-07 -0.0995321410677637 -1.9931 0.7062800807983127 0.7062788838545375 1.5052707346210892e-07 -0.09953228286221426 -1.9932 0.7062803337626565 0.7062791326446507 1.5130968377546905e-07 -0.09953242461379175 -1.9933 0.7062805866588977 0.7062793813509773 1.5204731289644724e-07 -0.09953256632250905 -1.9934 0.7062808394865745 0.7062796299740248 1.5273980449176383e-07 -0.09953270798837908 -1.9935 0.7062810922452238 0.7062798785143021 1.5338701267464394e-07 -0.09953284961141474 -1.9936 0.706281344934381 0.7062801269723198 1.53988802001348e-07 -0.0995329911916289 -1.9937 0.7062815975535799 0.70628037534859 1.5454504752321352e-07 -0.09953313272903451 -1.9938000000000002 0.7062818501023534 0.7062806236436253 1.550556348421661e-07 -0.09953327422364439 -1.9939 0.7062821025802332 0.7062808718579401 1.5552046010031129e-07 -0.09953341567547146 -1.994 0.7062823549867494 0.7062811199920489 1.5593942999381216e-07 -0.09953355708452848 -1.9941000000000002 0.7062826073214324 0.7062813680464682 1.5631246179717562e-07 -0.09953369845082843 -1.9942 0.706282859583811 0.7062816160217145 1.566394834083551e-07 -0.09953383977438417 -1.9943000000000002 0.7062831117734136 0.706281863918305 1.5692043332793393e-07 -0.09953398105520851 -1.9944000000000002 0.7062833638897681 0.706282111736758 1.5715526066606422e-07 -0.09953412229331442 -1.9945 0.7062836159324017 0.7062823594775913 1.5734392519797802e-07 -0.09953426348871464 -1.9946000000000002 0.7062838679008417 0.706282607141324 1.5748639733276226e-07 -0.09953440464142212 -1.9947000000000001 0.706284119794615 0.7062828547284741 1.5758265809601157e-07 -0.09953454575144963 -1.9948000000000001 0.7062843716132484 0.7062831022395607 1.5763269919574774e-07 -0.09953468681881004 -1.9949000000000001 0.7062846233562684 0.7062833496751025 1.5763652294262243e-07 -0.09953482784351611 -1.995 0.7062848750232025 0.7062835970356184 1.5759414232971447e-07 -0.09953496882558083 -1.9951 0.7062851266135778 0.7062838443216265 1.5750558094232425e-07 -0.09953510976501695 -1.9952 0.7062853781269222 0.7062840915336448 1.5737087302042374e-07 -0.09953525066183734 -1.9953 0.7062856295627635 0.7062843386721905 1.571900634066148e-07 -0.0995353915160548 -1.9954 0.7062858809206305 0.7062845857377806 1.5696320754612914e-07 -0.09953553232768213 -1.9955 0.7062861322000528 0.7062848327309309 1.5669037147295062e-07 -0.09953567309673214 -1.9956 0.7062863834005605 0.7062850796521569 1.5637163177859015e-07 -0.09953581382321768 -1.9957 0.7062866345216849 0.7062853265019728 1.5600707561555516e-07 -0.09953595450715154 -1.9958000000000002 0.7062868855629585 0.7062855732808915 1.5559680064183845e-07 -0.0995360951485465 -1.9959 0.7062871365239147 0.7062858199894255 1.5514091500704041e-07 -0.09953623574741546 -1.996 0.7062873874040884 0.7062860666280852 1.5463953734543012e-07 -0.09953637630377116 -1.9961000000000002 0.7062876382030152 0.7062863131973801 1.540927967204342e-07 -0.09953651681762637 -1.9962 0.7062878889202333 0.7062865596978176 1.5350083260728953e-07 -0.0995366572889939 -1.9963000000000002 0.7062881395552819 0.7062868061299041 1.5286379485487944e-07 -0.09953679771788654 -1.9964000000000002 0.706288390107702 0.7062870524941438 1.5218184363022247e-07 -0.09953693810431707 -1.9965 0.7062886405770363 0.7062872987910396 1.5145514939418625e-07 -0.09953707844829827 -1.9966000000000002 0.7062888909628298 0.7062875450210919 1.5068389287026251e-07 -0.09953721874984298 -1.9967000000000001 0.706289141264629 0.7062877911847991 1.4986826498558647e-07 -0.09953735900896385 -1.9968000000000001 0.7062893914819833 0.7062880372826578 1.4900846682236457e-07 -0.09953749922567373 -1.9969000000000001 0.7062896416144437 0.7062882833151618 1.4810470956930222e-07 -0.09953763939998533 -1.997 0.706289891661564 0.7062885292828028 1.471572144695621e-07 -0.09953777953191148 -1.9971 0.7062901416229003 0.7062887751860699 1.4616621277913078e-07 -0.09953791962146485 -1.9972 0.7062903914980116 0.7062890210254498 1.4513194570783816e-07 -0.09953805966865825 -1.9973 0.7062906412864591 0.706289266801426 1.4405466433262126e-07 -0.09953819967350443 -1.9974 0.7062908909878074 0.70628951251448 1.4293462955936032e-07 -0.09953833963601616 -1.9975 0.7062911406016233 0.7062897581650895 1.417721120812454e-07 -0.09953847955620614 -1.9976 0.7062913901274774 0.7062900037537299 1.4056739226775417e-07 -0.09953861943408714 -1.9977 0.7062916395649426 0.7062902492808725 1.3932076015424344e-07 -0.09953875926967182 -1.9978000000000002 0.7062918889135956 0.7062904947469864 1.380325153031714e-07 -0.09953889906297296 -1.9979 0.7062921381730165 0.7062907401525367 1.3670296677981142e-07 -0.09953903881400328 -1.998 0.7062923873427884 0.7062909854979855 1.353324330724548e-07 -0.09953917852277552 -1.9981000000000002 0.7062926364224983 0.7062912307837914 1.3392124200220512e-07 -0.09953931818930245 -1.9982 0.7062928854117365 0.7062914760104084 1.324697306639977e-07 -0.09953945781359667 -1.9983000000000002 0.7062931343100972 0.706291721178288 1.3097824532251612e-07 -0.09953959739567098 -1.9984000000000002 0.7062933831171785 0.706291966287877 1.2944714136015056e-07 -0.09953973693553803 -1.9985 0.7062936318325822 0.7062922113396191 1.2787678314862827e-07 -0.09953987643321055 -1.9986000000000002 0.7062938804559142 0.7062924563339528 1.2626754399697182e-07 -0.0995400158887012 -1.9987000000000001 0.7062941289867847 0.7062927012713136 1.2461980607170187e-07 -0.09954015530202276 -1.9988000000000001 0.7062943774248076 0.7062929461521322 1.2293396027887593e-07 -0.09954029467318781 -1.9989000000000001 0.7062946257696021 0.7062931909768353 1.21210406160005e-07 -0.09954043400220919 -1.999 0.7062948740207904 0.706293435745845 1.1944955185042017e-07 -0.09954057328909945 -1.9991 0.7062951221780005 0.7062936804595789 1.1765181393008639e-07 -0.09954071253387131 -1.9992 0.7062953702408639 0.7062939251184499 1.1581761736809137e-07 -0.09954085173653748 -1.9993 0.7062956182090172 0.7062941697228664 1.1394739538039822e-07 -0.09954099089711056 -1.9994 0.7062958660821022 0.7062944142732324 1.1204158935004815e-07 -0.09954113001560329 -1.9995 0.7062961138597645 0.7062946587699462 1.1010064872654657e-07 -0.0995412690920283 -1.9996 0.7062963615416556 0.7062949032134018 1.0812503091137127e-07 -0.09954140812639821 -1.9997 0.7062966091274321 0.7062951476039886 1.0611520114695017e-07 -0.09954154711872586 -1.9998000000000002 0.7062968566167543 0.7062953919420898 1.0407163242645567e-07 -0.09954168606902371 -1.9999 0.706297104009289 0.7062956362280842 1.019948053619657e-07 -0.09954182497730452 -2.0 0.7062973513047078 0.7062958804623449 9.988520808384971e-08 -0.09954196384358088 -2.0001 0.7062975985026874 0.7062961246452402 9.774333610892971e-08 -0.09954210266786545 -2.0002 0.7062978456029103 0.7062963687771322 9.556969225721357e-08 -0.09954224145017083 -2.0003 0.7062980926050642 0.7062966128583784 9.33647864923004e-08 -0.0995423801905097 -2.0004 0.7062983395088425 0.7062968568893304 9.112913583811388e-08 -0.09954251888889475 -2.0005 0.7062985863139443 0.7062971008703338 8.886326421930768e-08 -0.0995426575453385 -2.0006 0.7062988330200739 0.7062973448017291 8.656770240228484e-08 -0.09954279615985365 -2.0007 0.706299079626942 0.7062975886838501 8.424298778876571e-08 -0.09954293473245274 -2.0008000000000004 0.7062993261342652 0.7062978325170257 8.188966435854206e-08 -0.09954307326314847 -2.0009 0.706299572541765 0.7062980763015786 7.950828250467834e-08 -0.09954321175195341 -2.001 0.70629981884917 0.7062983200378252 7.709939892075468e-08 -0.09954335019888017 -2.0011 0.7063000650562141 0.7062985637260759 7.466357646208899e-08 -0.0995434886039413 -2.0012 0.7063003111626383 0.7062988073666356 7.220138401910214e-08 -0.09954362696714951 -2.0013 0.7063005571681882 0.7062990509598024 6.971339638200957e-08 -0.09954376528851733 -2.0014000000000003 0.7063008030726174 0.7062992945058684 6.720019410030864e-08 -0.09954390356805745 -2.0015 0.7063010488756843 0.7062995380051191 6.46623633682869e-08 -0.09954404180578237 -2.0016000000000003 0.7063012945771545 0.7062997814578342 6.210049587930533e-08 -0.09954418000170472 -2.0017 0.7063015401767998 0.7063000248642859 5.951518866273431e-08 -0.09954431815583702 -2.0018000000000002 0.7063017856743985 0.7063002682247413 5.690704399548274e-08 -0.09954445626819193 -2.0019 0.7063020310697351 0.7063005115394598 5.4276669202504846e-08 -0.09954459433878195 -2.002 0.7063022763626011 0.7063007548086951 5.162467655792091e-08 -0.09954473236761967 -2.0021 0.7063025215527945 0.7063009980326937 4.8951683132361645e-08 -0.09954487035471768 -2.0022 0.70630276664012 0.7063012412116958 4.625831064725139e-08 -0.09954500830008857 -2.0023 0.7063030116243887 0.7063014843459343 4.354518532388718e-08 -0.09954514620374483 -2.0024 0.7063032565054188 0.7063017274356358 4.08129377533345e-08 -0.09954528406569906 -2.0025 0.7063035012830352 0.7063019704810203 3.80622027298938e-08 -0.09954542188596381 -2.0026 0.7063037459570698 0.7063022134822999 3.529361912273099e-08 -0.09954555966455157 -2.0027 0.7063039905273611 0.7063024564396813 3.2507829721487025e-08 -0.09954569740147497 -2.0028 0.7063042349937549 0.7063026993533629 2.9705481073213913e-08 -0.09954583509674651 -2.0029 0.7063044793561039 0.7063029422235367 2.688722335747462e-08 -0.09954597275037878 -2.003 0.7063047236142674 0.7063031850503878 2.405371020419711e-08 -0.09954611036238423 -2.0031000000000003 0.7063049677681126 0.7063034278340938 2.1205598579182583e-08 -0.09954624793277551 -2.0032 0.7063052118175126 0.7063036705748256 1.8343548601092163e-08 -0.09954638546156501 -2.0033000000000003 0.7063054557623485 0.7063039132727468 1.5468223409607906e-08 -0.09954652294876531 -2.0034 0.7063056996025083 0.7063041559280139 1.2580288993695177e-08 -0.09954666039438897 -2.0035 0.7063059433378872 0.706304398540776 9.680414051090047e-09 -0.09954679779844844 -2.0036 0.7063061869683875 0.7063046411111754 6.769269825235291e-09 -0.09954693516095625 -2.0037000000000003 0.7063064304939188 0.7063048836393468 3.847529957828888e-09 -0.09954707248192493 -2.0038 0.7063066739143982 0.7063051261254181 9.158703274947388e-10 -0.09954720976136702 -2.0039000000000002 0.7063069172297494 0.7063053685695089 -2.025031110679254e-09 -0.0995473469992949 -2.004 0.7063071604399043 0.7063056109717327 -4.9744944717253214e-09 -0.0995474841957212 -2.0041 0.7063074035448013 0.7063058533321952 -7.931838101257749e-09 -0.09954762135065837 -2.0042 0.7063076465443866 0.7063060956509944 -1.0896378735934797e-08 -0.0995477584641189 -2.0043 0.7063078894386134 0.7063063379282213 -1.3867431664787988e-08 -0.0995478955361152 -2.0044 0.7063081322274423 0.7063065801639594 -1.6844310876239915e-08 -0.09954803256665978 -2.0045 0.7063083749108421 0.7063068223582853 -1.98263292246377e-08 -0.09954816955576523 -2.0046 0.7063086174887876 0.7063070645112676 -2.281279858767915e-08 -0.09954830650344393 -2.0047 0.706308859961262 0.7063073066229674 -2.5803030021670503e-08 -0.09954844340970832 -2.0048000000000004 0.7063091023282555 0.7063075486934389 -2.879633392502412e-08 -0.09954858027457093 -2.0049 0.706309344589766 0.7063077907227289 -3.179202019481728e-08 -0.0995487170980442 -2.005 0.7063095867457985 0.7063080327108766 -3.478939838616989e-08 -0.09954885388014068 -2.0051 0.706309828796365 0.7063082746579132 -3.778777786967065e-08 -0.09954899062087265 -2.0052 0.7063100707414862 0.7063085165638637 -4.078646799341107e-08 -0.09954912732025273 -2.0053 0.7063103125811888 0.7063087584287444 -4.378477824019478e-08 -0.09954926397829322 -2.0054000000000003 0.7063105543155077 0.7063090002525653 -4.678201838767418e-08 -0.09954940059500667 -2.0055 0.706310795944485 0.7063092420353283 -4.977749866615609e-08 -0.09954953717040547 -2.0056000000000003 0.70631103746817 0.7063094837770278 -5.2770529915648415e-08 -0.09954967370450209 -2.0057 0.7063112788866199 0.7063097254776516 -5.5760423749466256e-08 -0.09954981019730894 -2.0058000000000002 0.7063115201998987 0.7063099671371793 -5.8746492706453907e-08 -0.09954994664883844 -2.0059 0.7063117614080782 0.7063102087555839 -6.172805041204307e-08 -0.0995500830591031 -2.006 0.706312002511237 0.7063104503328298 -6.470441173914848e-08 -0.09955021942811525 -2.0061 0.7063122435094618 0.7063106918688754 -6.767489295778778e-08 -0.09955035575588732 -2.0062 0.7063124844028457 0.7063109333636712 -7.063881190053078e-08 -0.09955049204243177 -2.0063 0.7063127251914897 0.7063111748171602 -7.359548811255306e-08 -0.09955062828776094 -2.0064 0.7063129658755023 0.7063114162292785 -7.654424300992946e-08 -0.09955076449188735 -2.0065 0.7063132064549984 0.7063116575999547 -7.948440003489182e-08 -0.0995509006548233 -2.0066 0.7063134469301007 0.7063118989291102 -8.241528481282151e-08 -0.09955103677658123 -2.0067 0.7063136873009392 0.7063121402166592 -8.533622530924184e-08 -0.09955117285717352 -2.0068 0.7063139275676507 0.7063123814625087 -8.824655197553488e-08 -0.09955130889661253 -2.0069 0.7063141677303797 0.7063126226665591 -9.114559790940335e-08 -0.0995514448949108 -2.007 0.7063144077892769 0.7063128638287025 -9.403269900492423e-08 -0.09955158085208055 -2.0071000000000003 0.706314647744501 0.7063131049488247 -9.690719410433701e-08 -0.0995517167681342 -2.0072 0.7063148875962174 0.7063133460268043 -9.976842515330153e-08 -0.0995518526430842 -2.0073000000000003 0.7063151273445982 0.7063135870625128 -1.0261573734401258e-07 -0.09955198847694284 -2.0074 0.7063153669898232 0.7063138280558148 -1.0544847927566187e-07 -0.09955212426972254 -2.0075 0.7063156065320784 0.7063140690065681 -1.0826600308714435e-07 -0.09955226002143565 -2.0076 0.7063158459715568 0.7063143099146232 -1.1106766462966322e-07 -0.09955239573209454 -2.0077000000000003 0.7063160853084591 0.7063145507798236 -1.1385282358208904e-07 -0.09955253140171152 -2.0078 0.7063163245429915 0.7063147916020068 -1.1662084362790148e-07 -0.099552667030299 -2.0079000000000002 0.7063165636753684 0.706315032381003 -1.1937109258355894e-07 -0.09955280261786938 -2.008 0.7063168027058101 0.7063152731166356 -1.221029425398784e-07 -0.09955293816443497 -2.0081 0.7063170416345428 0.706315513808721 -1.2481577002509958e-07 -0.09955307367000804 -2.0082 0.7063172804618012 0.70631575445707 -1.2750895612458069e-07 -0.09955320913460104 -2.0083 0.7063175191878248 0.7063159950614853 -1.301818866334542e-07 -0.09955334455822622 -2.0084 0.706317757812861 0.7063162356217645 -1.3283395219713945e-07 -0.09955347994089593 -2.0085 0.7063179963371626 0.7063164761376981 -1.3546454844144684e-07 -0.09955361528262255 -2.0086 0.7063182347609896 0.70631671660907 -1.380730761200294e-07 -0.09955375058341837 -2.0087 0.706318473084608 0.7063169570356582 -1.406589412462217e-07 -0.09955388584329573 -2.0088000000000004 0.70631871130829 0.7063171974172336 -1.4322155523528723e-07 -0.09955402106226693 -2.0089 0.7063189494323142 0.7063174377535618 -1.4576033501197128e-07 -0.09955415624034426 -2.009 0.7063191874569654 0.7063176780444019 -1.482747031926468e-07 -0.09955429137754014 -2.0091 0.7063194253825347 0.7063179182895065 -1.507640881668465e-07 -0.0995544264738668 -2.0092 0.7063196632093185 0.7063181584886222 -1.5322792425685738e-07 -0.09955456152933653 -2.0093 0.7063199009376202 0.7063183986414902 -1.5566565182874303e-07 -0.09955469654396167 -2.0094000000000003 0.7063201385677487 0.7063186387478447 -1.5807671743632568e-07 -0.09955483151775449 -2.0095 0.7063203761000183 0.7063188788074153 -1.6046057393220847e-07 -0.09955496645072733 -2.0096000000000003 0.7063206135347496 0.7063191188199248 -1.6281668060308396e-07 -0.0995551013428924 -2.0097 0.7063208508722688 0.7063193587850904 -1.6514450328075636e-07 -0.09955523619426199 -2.0098000000000003 0.7063210881129081 0.7063195987026245 -1.6744351447398054e-07 -0.09955537100484849 -2.0099 0.7063213252570044 0.7063198385722327 -1.6971319347428016e-07 -0.09955550577466406 -2.01 0.7063215623049008 0.7063200783936159 -1.7195302648952138e-07 -0.09955564050372101 -2.0101 0.7063217992569462 0.7063203181664697 -1.7416250676187406e-07 -0.09955577519203171 -2.0102 0.7063220361134932 0.7063205578904833 -1.763411346528132e-07 -0.09955590983960827 -2.0103 0.7063222728749017 0.7063207975653418 -1.7848841779924407e-07 -0.09955604444646306 -2.0104 0.7063225095415353 0.7063210371907247 -1.806038711880953e-07 -0.09955617901260833 -2.0105 0.7063227461137633 0.7063212767663057 -1.8268701730203563e-07 -0.09955631353805627 -2.0106 0.7063229825919601 0.7063215162917545 -1.8473738617671986e-07 -0.09955644802281918 -2.0107 0.7063232189765051 0.7063217557667355 -1.8675451554650557e-07 -0.09955658246690935 -2.0108 0.7063234552677818 0.7063219951909077 -1.8873795093812817e-07 -0.09955671687033893 -2.0109 0.7063236914661793 0.7063222345639261 -1.906872457782538e-07 -0.0995568512331202 -2.011 0.7063239275720913 0.7063224738854406 -1.9260196146980713e-07 -0.09955698555526547 -2.0111000000000003 0.7063241635859157 0.7063227131550963 -1.9448166753768814e-07 -0.09955711983678689 -2.0112 0.7063243995080553 0.7063229523725346 -1.9632594167387496e-07 -0.09955725407769678 -2.0113000000000003 0.7063246353389172 0.7063231915373913 -1.9813436987273225e-07 -0.0995573882780073 -2.0114 0.7063248710789125 0.7063234306492985 -1.9990654647611406e-07 -0.09955752243773065 -2.0115 0.706325106728457 0.7063236697078842 -2.0164207432601944e-07 -0.09955765655687913 -2.0116 0.7063253422879707 0.7063239087127717 -2.033405648166342e-07 -0.09955779063546488 -2.0117000000000003 0.706325577757877 0.7063241476635804 -2.0500163797759763e-07 -0.09955792467350012 -2.0118 0.7063258131386037 0.7063243865599266 -2.0662492256420806e-07 -0.09955805867099711 -2.0119000000000002 0.7063260484305829 0.7063246254014213 -2.08210056151098e-07 -0.09955819262796803 -2.012 0.7063262836342495 0.7063248641876725 -2.097566852050925e-07 -0.09955832654442504 -2.0121 0.7063265187500434 0.7063251029182845 -2.112644651650064e-07 -0.09955846042038041 -2.0122 0.7063267537784066 0.706325341592858 -2.127330605145028e-07 -0.09955859425584629 -2.0123 0.7063269887197854 0.7063255802109899 -2.1416214486535967e-07 -0.09955872805083489 -2.0124 0.7063272235746297 0.7063258187722743 -2.155514010129811e-07 -0.09955886180535842 -2.0125 0.7063274583433923 0.7063260572763012 -2.169005210300723e-07 -0.09955899551942905 -2.0126 0.706327693026529 0.7063262957226579 -2.182092063221508e-07 -0.09955912919305894 -2.0127 0.7063279276244989 0.7063265341109285 -2.1947716769693537e-07 -0.09955926282626024 -2.0128000000000004 0.7063281621377644 0.7063267724406943 -2.2070412541985718e-07 -0.09955939641904521 -2.0129 0.7063283965667899 0.7063270107115336 -2.2188980927997926e-07 -0.09955952997142592 -2.013 0.7063286309120437 0.7063272489230217 -2.2303395866285491e-07 -0.0995596634834146 -2.0131 0.706328865173996 0.7063274870747313 -2.2413632257134442e-07 -0.09955979695502337 -2.0132 0.7063290993531197 0.7063277251662328 -2.2519665973316783e-07 -0.09955993038626446 -2.0133 0.7063293334498902 0.7063279631970936 -2.2621473859049668e-07 -0.0995600637771499 -2.0134000000000003 0.7063295674647856 0.7063282011668794 -2.271903374283235e-07 -0.09956019712769199 -2.0135 0.7063298013982858 0.7063284390751531 -2.281232443640535e-07 -0.09956033043790274 -2.0136000000000003 0.706330035250873 0.7063286769214757 -2.2901325737179068e-07 -0.09956046370779441 -2.0137 0.7063302690230315 0.7063289147054064 -2.2986018440029898e-07 -0.09956059693737913 -2.0138000000000003 0.7063305027152476 0.7063291524265014 -2.3066384337994128e-07 -0.09956073012666895 -2.0139 0.7063307363280089 0.7063293900843162 -2.3142406224696543e-07 -0.09956086327567608 -2.014 0.7063309698618054 0.7063296276784041 -2.3214067898513768e-07 -0.09956099638441263 -2.0141 0.7063312033171283 0.706329865208317 -2.328135416812538e-07 -0.09956112945289067 -2.0142 0.7063314366944705 0.7063301026736047 -2.3344250854248627e-07 -0.09956126248112239 -2.0143 0.7063316699943261 0.7063303400738166 -2.3402744790679275e-07 -0.09956139546911988 -2.0144 0.7063319032171907 0.7063305774084998 -2.34568238305366e-07 -0.09956152841689526 -2.0145 0.7063321363635608 0.7063308146772009 -2.3506476845916446e-07 -0.09956166132446066 -2.0146 0.7063323694339343 0.706331051879465 -2.3551693732401513e-07 -0.09956179419182812 -2.0147 0.7063326024288098 0.7063312890148363 -2.3592465410102181e-07 -0.09956192701900984 -2.0148 0.7063328353486867 0.7063315260828588 -2.3628783824697353e-07 -0.09956205980601786 -2.0149 0.7063330681940656 0.7063317630830745 -2.366064194986306e-07 -0.0995621925528643 -2.015 0.7063333009654471 0.7063320000150262 -2.3688033788660245e-07 -0.09956232525956127 -2.0151000000000003 0.7063335336633328 0.7063322368782549 -2.37109543745756e-07 -0.09956245792612084 -2.0152 0.7063337662882241 0.706332473672302 -2.3729399771521553e-07 -0.0995625905525551 -2.0153000000000003 0.7063339988406233 0.7063327103967081 -2.3743367075917954e-07 -0.09956272313887607 -2.0154 0.7063342313210328 0.7063329470510141 -2.3752854414957336e-07 -0.09956285568509597 -2.0155 0.7063344637299545 0.7063331836347606 -2.3757860948339649e-07 -0.09956298819122675 -2.0156 0.706334696067891 0.7063334201474878 -2.3758386867925307e-07 -0.09956312065728051 -2.0157 0.7063349283353443 0.7063336565887368 -2.3754433398082142e-07 -0.09956325308326931 -2.0158 0.7063351605328163 0.7063338929580485 -2.374600279395067e-07 -0.09956338546920526 -2.0159000000000002 0.7063353926608082 0.7063341292549643 -2.373309833901549e-07 -0.0995635178151004 -2.016 0.7063356247198211 0.706334365479026 -2.3715724348574718e-07 -0.09956365012096674 -2.0161000000000002 0.7063358567103557 0.706334601629776 -2.3693886163841937e-07 -0.0995637823868164 -2.0162 0.7063360886329114 0.7063348377067574 -2.3667590152293139e-07 -0.0995639146126614 -2.0163 0.7063363204879871 0.706335073709514 -2.3636843707319777e-07 -0.09956404679851374 -2.0164 0.7063365522760809 0.7063353096375908 -2.3601655244759323e-07 -0.09956417894438559 -2.0165 0.70633678399769 0.7063355454905338 -2.3562034199078874e-07 -0.09956431105028894 -2.0166 0.7063370156533094 0.7063357812678899 -2.3517991023722096e-07 -0.0995644431162358 -2.0167 0.7063372472434339 0.7063360169692069 -2.34695371893745e-07 -0.09956457514223818 -2.0168000000000004 0.706337478768557 0.7063362525940349 -2.3416685174595941e-07 -0.09956470712830816 -2.0169 0.7063377102291699 0.7063364881419245 -2.335944847033089e-07 -0.09956483907445773 -2.017 0.7063379416257629 0.7063367236124285 -2.3297841571928712e-07 -0.09956497098069889 -2.0171 0.7063381729588243 0.7063369590051012 -2.3231879977061998e-07 -0.09956510284704365 -2.0172 0.7063384042288409 0.7063371943194986 -2.316158018121628e-07 -0.09956523467350413 -2.0173 0.7063386354362973 0.7063374295551786 -2.3086959673179752e-07 -0.09956536646009226 -2.0174000000000003 0.7063388665816761 0.7063376647117012 -2.3008036931573828e-07 -0.09956549820682004 -2.0175 0.7063390976654582 0.706337899788628 -2.292483142034285e-07 -0.09956562991369948 -2.0176000000000003 0.7063393286881221 0.7063381347855239 -2.2837363585284653e-07 -0.0995657615807426 -2.0177 0.7063395596501432 0.706338369701955 -2.274565484537694e-07 -0.09956589320796137 -2.0178000000000003 0.7063397905519957 0.7063386045374904 -2.2649727590001723e-07 -0.09956602479536783 -2.0179 0.7063400213941506 0.7063388392917014 -2.254960517582283e-07 -0.0995661563429739 -2.018 0.7063402521770766 0.7063390739641622 -2.2445311912908106e-07 -0.09956628785079169 -2.0181 0.7063404829012392 0.7063393085544498 -2.2336873070627483e-07 -0.0995664193188331 -2.0182 0.7063407135671014 0.7063395430621435 -2.2224314861693517e-07 -0.09956655074711009 -2.0183 0.7063409441751228 0.7063397774868259 -2.2107664441814445e-07 -0.09956668213563463 -2.0184 0.7063411747257609 0.7063400118280827 -2.1986949897204178e-07 -0.09956681348441875 -2.0185 0.7063414052194692 0.7063402460855024 -2.1862200245970076e-07 -0.09956694479347435 -2.0186 0.7063416356566983 0.7063404802586768 -2.173344542458211e-07 -0.09956707606281343 -2.0187 0.7063418660378955 0.7063407143472016 -2.1600716281974797e-07 -0.09956720729244795 -2.0188 0.7063420963635049 0.706340948350675 -2.1464044574343033e-07 -0.09956733848238986 -2.0189 0.7063423266339662 0.7063411822686994 -2.1323462954733752e-07 -0.0995674696326511 -2.019 0.7063425568497163 0.7063414161008803 -2.1179004968188697e-07 -0.09956760074324363 -2.0191000000000003 0.7063427870111881 0.7063416498468272 -2.1030705041336084e-07 -0.09956773181417937 -2.0192 0.706343017118811 0.706341883506154 -2.0878598476492538e-07 -0.09956786284547034 -2.0193000000000003 0.7063432471730102 0.7063421170784772 -2.072272144021392e-07 -0.09956799383712844 -2.0194 0.7063434771742068 0.7063423505634179 -2.0563110958091158e-07 -0.09956812478916559 -2.0195 0.7063437071228178 0.7063425839606017 -2.0399804901219398e-07 -0.09956825570159371 -2.0196 0.7063439370192567 0.7063428172696579 -2.0232841984810235e-07 -0.09956838657442481 -2.0197 0.7063441668639319 0.70634305049022 -2.0062261752232247e-07 -0.09956851740767074 -2.0198 0.7063443966572479 0.7063432836219257 -1.9888104567725162e-07 -0.09956864820134342 -2.0199000000000003 0.7063446263996045 0.7063435166644175 -1.9710411606338463e-07 -0.0995687789554548 -2.02 0.7063448560913972 0.7063437496173426 -1.9529224847339433e-07 -0.09956890967001675 -2.0201000000000002 0.7063450857330167 0.7063439824803522 -1.9344587059294538e-07 -0.09956904034504123 -2.0202 0.7063453153248493 0.7063442152531025 -1.9156541794865256e-07 -0.09956917098054013 -2.0203 0.7063455448672761 0.7063444479352546 -1.8965133376930288e-07 -0.09956930157652533 -2.0204 0.7063457743606735 0.7063446805264741 -1.8770406890258884e-07 -0.09956943213300873 -2.0205 0.7063460038054135 0.7063449130264319 -1.8572408169714727e-07 -0.09956956265000227 -2.0206 0.7063462332018622 0.7063451454348035 -1.837118379054148e-07 -0.0995696931275178 -2.0207 0.7063464625503812 0.7063453777512696 -1.8166781055872772e-07 -0.0995698235655672 -2.0208000000000004 0.706346691851327 0.7063456099755161 -1.7959247987364702e-07 -0.0995699539641624 -2.0209 0.7063469211050502 0.7063458421072346 -1.774863331201193e-07 -0.09957008432331528 -2.021 0.706347150311897 0.7063460741461213 -1.7534986453474066e-07 -0.09957021464303772 -2.0211 0.7063473794722073 0.7063463060918782 -1.7318357517157046e-07 -0.09957034492334159 -2.0212 0.7063476085863156 0.7063465379442123 -1.7098797281019096e-07 -0.09957047516423868 -2.0213 0.7063478376545518 0.7063467697028369 -1.687635718273378e-07 -0.099570605365741 -2.0214000000000003 0.7063480666772395 0.7063470013674704 -1.6651089307893885e-07 -0.09957073552786032 -2.0215 0.7063482956546965 0.7063472329378366 -1.6423046377347927e-07 -0.09957086565060855 -2.0216000000000003 0.7063485245872354 0.7063474644136655 -1.6192281735057101e-07 -0.09957099573399752 -2.0217 0.7063487534751622 0.7063476957946927 -1.5958849335778735e-07 -0.09957112577803909 -2.0218000000000003 0.7063489823187779 0.7063479270806595 -1.5722803732576285e-07 -0.09957125578274506 -2.0219 0.7063492111183769 0.7063481582713136 -1.5484200064502796e-07 -0.09957138574812736 -2.022 0.706349439874248 0.7063483893664083 -1.5243094041855754e-07 -0.09957151567419781 -2.0221 0.7063496685866739 0.7063486203657029 -1.4999541934901384e-07 -0.0995716455609682 -2.0222 0.7063498972559309 0.7063488512689629 -1.475360056138464e-07 -0.09957177540845041 -2.0223 0.7063501258822893 0.7063490820759599 -1.450532727091669e-07 -0.09957190521665625 -2.0224 0.7063503544660135 0.7063493127864722 -1.425477993335228e-07 -0.09957203498559758 -2.0225 0.7063505830073612 0.7063495434002838 -1.4002016924738458e-07 -0.09957216471528622 -2.0226 0.7063508115065839 0.7063497739171848 -1.374709711413069e-07 -0.09957229440573395 -2.0227 0.7063510399639265 0.7063500043369725 -1.349007984936812e-07 -0.09957242405695263 -2.0228 0.7063512683796278 0.7063502346594499 -1.3231024943716196e-07 -0.09957255366895403 -2.0229 0.7063514967539202 0.706350464884427 -1.2969992661121532e-07 -0.09957268324175005 -2.023 0.7063517250870293 0.7063506950117199 -1.2707043704068832e-07 -0.09957281277535242 -2.0231000000000003 0.706351953379174 0.7063509250411515 -1.2442239196927551e-07 -0.09957294226977298 -2.0232 0.706352181630567 0.7063511549725511 -1.2175640673461885e-07 -0.0995730717250235 -2.0233000000000003 0.706352409841414 0.7063513848057548 -1.1907310062085619e-07 -0.09957320114111581 -2.0234 0.7063526380119143 0.7063516145406055 -1.1637309672331286e-07 -0.09957333051806172 -2.0235 0.7063528661422602 0.7063518441769527 -1.1365702178196824e-07 -0.09957345985587304 -2.0236 0.7063530942326375 0.7063520737146523 -1.1092550606002505e-07 -0.09957358915456149 -2.0237 0.7063533222832243 0.7063523031535675 -1.081791831808454e-07 -0.09957371841413884 -2.0238 0.7063535502941933 0.7063525324935682 -1.0541868999611181e-07 -0.09957384763461687 -2.0239000000000003 0.7063537782657092 0.7063527617345311 -1.0264466642363052e-07 -0.09957397681600742 -2.024 0.7063540061979303 0.7063529908763401 -9.985775530334945e-08 -0.09957410595832228 -2.0241000000000002 0.7063542340910078 0.7063532199188856 -9.705860225511093e-08 -0.09957423506157315 -2.0242 0.7063544619450859 0.7063534488620649 -9.424785552079179e-08 -0.09957436412577177 -2.0243 0.7063546897603019 0.7063536777057825 -9.142616582292346e-08 -0.09957449315092996 -2.0244 0.7063549175367859 0.7063539064499501 -8.859418620336262e-08 -0.09957462213705945 -2.0245 0.7063551452746613 0.7063541350944862 -8.575257188104396e-08 -0.099574751084172 -2.0246 0.7063553729740444 0.7063543636393167 -8.290198009585498e-08 -0.09957487999227944 -2.0247 0.706355600635044 0.7063545920843737 -8.004306995944982e-08 -0.09957500886139344 -2.0248000000000004 0.706355828257762 0.7063548204295973 -7.717650230172624e-08 -0.09957513769152573 -2.0249 0.7063560558422934 0.7063550486749339 -7.430293951556782e-08 -0.09957526648268807 -2.025 0.7063562833887258 0.706355276820338 -7.142304540895886e-08 -0.0995753952348922 -2.0251 0.7063565108971397 0.7063555048657705 -6.853748504538973e-08 -0.09957552394814985 -2.0252 0.706356738367609 0.7063557328111997 -6.564692460030858e-08 -0.09957565262247281 -2.0253 0.7063569658001997 0.7063559606566008 -6.275203119502151e-08 -0.09957578125787275 -2.0254000000000003 0.7063571931949706 0.7063561884019565 -5.985347275184322e-08 -0.09957590985436138 -2.0255 0.7063574205519736 0.7063564160472566 -5.6951917834285534e-08 -0.09957603841195044 -2.0256000000000003 0.7063576478712534 0.706356643592498 -5.404803549830493e-08 -0.09957616693065163 -2.0257 0.7063578751528476 0.7063568710376847 -5.1142495134442675e-08 -0.09957629541047672 -2.0258000000000003 0.7063581023967871 0.7063570983828281 -4.823596631603651e-08 -0.0995764238514374 -2.0259 0.7063583296030944 0.7063573256279465 -4.532911864141504e-08 -0.09957655225354539 -2.026 0.7063585567717854 0.7063575527730657 -4.242262158132338e-08 -0.09957668061681235 -2.0261 0.7063587839028688 0.7063577798182181 -3.9517144326945124e-08 -0.09957680894124997 -2.0262000000000002 0.7063590109963462 0.7063580067634438 -3.6613355635295095e-08 -0.09957693722686993 -2.0263 0.7063592380522122 0.7063582336087904 -3.371192367168478e-08 -0.09957706547368399 -2.0264 0.7063594650704538 0.7063584603543117 -3.0813515859316395e-08 -0.09957719368170376 -2.0265 0.7063596920510513 0.7063586870000695 -2.7918798724919577e-08 -0.09957732185094105 -2.0266 0.7063599189939773 0.7063589135461321 -2.502843774766783e-08 -0.09957744998140744 -2.0267 0.7063601458991978 0.7063591399925752 -2.2143097201752365e-08 -0.09957757807311463 -2.0268 0.7063603727666714 0.7063593663394814 -1.9263440006762195e-08 -0.09957770612607428 -2.0269 0.7063605995963496 0.7063595925869408 -1.6390127577196878e-08 -0.09957783414029804 -2.027 0.7063608263881767 0.7063598187350506 -1.352381966395616e-08 -0.09957796211579761 -2.0271000000000003 0.7063610531420904 0.7063600447839142 -1.066517421252633e-08 -0.09957809005258468 -2.0272 0.7063612798580211 0.7063602707336436 -7.814847204253017e-09 -0.09957821795067093 -2.0273000000000003 0.7063615065358921 0.7063604965843562 -4.9734925075886616e-09 -0.09957834581006798 -2.0274 0.7063617331756196 0.7063607223361767 -2.14176172977365e-09 -0.09957847363078745 -2.0275 0.7063619597771131 0.7063609479892375 6.796959332172614e-10 -0.09957860141284101 -2.0276 0.7063621863402748 0.7063611735436777 3.490233843259083e-09 -0.09957872915624033 -2.0277 0.7063624128650005 0.7063613989996428 6.2892080718648935e-09 -0.09957885686099702 -2.0278 0.7063626393511786 0.7063616243572854 9.075977551974146e-09 -0.09957898452712272 -2.0279000000000003 0.7063628657986913 0.7063618496167654 1.1849904208924289e-08 -0.09957911215462911 -2.028 0.7063630922074133 0.706362074778249 1.4610353123514774e-08 -0.09957923974352781 -2.0281000000000002 0.7063633185772129 0.706362299841909 1.735669266905021e-08 -0.09957936729383045 -2.0282 0.7063635449079515 0.7063625248079257 2.0088294657057137e-08 -0.09957949480554867 -2.0283 0.7063637711994839 0.7063627496764853 2.2804534479531346e-08 -0.09957962227869402 -2.0284 0.706363997451658 0.7063629744477808 2.5504791254654657e-08 -0.09957974971327818 -2.0285 0.7063642236643156 0.7063631991220123 2.818844796297071e-08 -0.09957987710931276 -2.0286 0.7063644498372912 0.7063634236993859 3.085489160177535e-08 -0.09958000446680933 -2.0287 0.7063646759704136 0.7063636481801148 3.350351331088408e-08 -0.09958013178577958 -2.0288000000000004 0.7063649020635046 0.7063638725644181 3.613370850794051e-08 -0.09958025906623512 -2.0289 0.7063651281163792 0.7063640968525218 3.874487704974561e-08 -0.09958038630818747 -2.029 0.7063653541288468 0.7063643210446577 4.133642334501475e-08 -0.09958051351164827 -2.0291 0.7063655801007102 0.7063645451410643 4.390775650356393e-08 -0.09958064067662911 -2.0292 0.7063658060317652 0.7063647691419865 4.645829046467931e-08 -0.09958076780314153 -2.0293 0.7063660319218027 0.706364993047675 4.898744413936451e-08 -0.09958089489119717 -2.0294 0.7063662577706062 0.7063652168583873 5.1494641514424067e-08 -0.0995810219408076 -2.0295 0.7063664835779537 0.7063654405743864 5.3979311834609356e-08 -0.09958114895198442 -2.0296000000000003 0.7063667093436172 0.7063656641959418 5.6440889696293683e-08 -0.09958127592473921 -2.0297 0.7063669350673625 0.706365887723329 5.887881515849458e-08 -0.09958140285908357 -2.0298000000000003 0.7063671607489492 0.7063661111568286 6.129253392501977e-08 -0.09958152975502903 -2.0299 0.7063673863881315 0.7063663344967279 6.368149742426443e-08 -0.09958165661258711 -2.03 0.7063676119846573 0.70636655774332 6.60451629462544e-08 -0.09958178343176943 -2.0301 0.7063678375382691 0.7063667808969034 6.838299378142398e-08 -0.09958191021258754 -2.0302000000000002 0.7063680630487037 0.7063670039577824 7.069445932990359e-08 -0.09958203695505297 -2.0303 0.7063682885156921 0.7063672269262671 7.297903520733784e-08 -0.09958216365917731 -2.0304 0.7063685139389599 0.7063674498026726 7.523620339407178e-08 -0.09958229032497211 -2.0305 0.706368739318227 0.7063676725873205 7.746545233056068e-08 -0.09958241695244889 -2.0306 0.7063689646532083 0.7063678952805369 7.966627703880069e-08 -0.09958254354161929 -2.0307 0.7063691899436129 0.7063681178826533 8.183817924375947e-08 -0.09958267009249472 -2.0308 0.7063694151891448 0.7063683403940069 8.398066747052069e-08 -0.09958279660508679 -2.0309 0.7063696403895027 0.7063685628149395 8.609325717785776e-08 -0.09958292307940701 -2.031 0.7063698655443804 0.7063687851457987 8.817547084497002e-08 -0.0995830495154669 -2.0311000000000003 0.7063700906534668 0.7063690073869364 9.022683808770915e-08 -0.09958317591327799 -2.0312 0.7063703157164453 0.7063692295387101 9.224689577480572e-08 -0.09958330227285181 -2.0313000000000003 0.7063705407329945 0.7063694516014818 9.423518811113585e-08 -0.09958342859419986 -2.0314 0.7063707657027888 0.7063696735756182 9.619126676782552e-08 -0.09958355487733367 -2.0315 0.7063709906254974 0.7063698954614911 9.811469095857839e-08 -0.09958368112226473 -2.0316 0.7063712155007846 0.7063701172594767 1.0000502755416751e-07 -0.09958380732900457 -2.0317 0.7063714403283108 0.706370338969956 1.0186185116917157e-07 -0.0995839334975647 -2.0318 0.7063716651077319 0.7063705605933142 1.0368474427646657e-07 -0.09958405962795669 -2.0319000000000003 0.7063718898386984 0.7063707821299405 1.0547329727314536e-07 -0.09958418572019193 -2.032 0.7063721145208577 0.7063710035802293 1.072271085811316e-07 -0.09958431177428195 -2.0321000000000002 0.7063723391538523 0.7063712249445784 1.0894578476861039e-07 -0.09958443779023826 -2.0322 0.7063725637373208 0.7063714462233901 1.1062894058819217e-07 -0.09958456376807232 -2.0323 0.7063727882708977 0.7063716674170706 1.1227619910181286e-07 -0.0995846897077956 -2.0324 0.7063730127542135 0.7063718885260303 1.138871917397144e-07 -0.09958481560941965 -2.0325 0.706373237186895 0.7063721095506829 1.154615584114671e-07 -0.09958494147295587 -2.0326 0.7063734615685653 0.7063723304914463 1.1699894754760298e-07 -0.09958506729841576 -2.0327 0.7063736858988434 0.706372551348742 1.1849901621410752e-07 -0.09958519308581079 -2.0328000000000004 0.7063739101773452 0.7063727721229951 1.1996143017140026e-07 -0.09958531883515248 -2.0329 0.7063741344036829 0.7063729928146341 1.2138586395066264e-07 -0.09958544454645224 -2.033 0.7063743585774651 0.7063732134240905 1.2277200092322693e-07 -0.09958557021972152 -2.0331 0.7063745826982978 0.7063734339518 1.2411953337690407e-07 -0.09958569585497179 -2.0332 0.7063748067657831 0.7063736543982005 1.2542816258190315e-07 -0.0995858214522146 -2.0333 0.7063750307795201 0.7063738747637338 1.266975988706287e-07 -0.09958594701146127 -2.0334 0.7063752547391053 0.7063740950488439 1.2792756165502794e-07 -0.0995860725327233 -2.0335 0.7063754786441319 0.7063743152539783 1.291177795480214e-07 -0.09958619801601214 -2.0336000000000003 0.7063757024941901 0.7063745353795872 1.3026799038778902e-07 -0.09958632346133922 -2.0337 0.706375926288868 0.706374755426123 1.3137794130715919e-07 -0.09958644886871593 -2.0338000000000003 0.706376150027751 0.7063749753940414 1.3244738879258922e-07 -0.09958657423815376 -2.0339 0.7063763737104216 0.7063751952838003 1.33476098711921e-07 -0.09958669956966412 -2.034 0.70637659733646 0.7063754150958599 1.3446384639070885e-07 -0.09958682486325843 -2.0341 0.7063768209054443 0.7063756348306826 1.3541041666773057e-07 -0.09958695011894814 -2.0342000000000002 0.7063770444169504 0.7063758544887331 1.36315603929682e-07 -0.09958707533674463 -2.0343 0.7063772678705518 0.7063760740704785 1.3717921213546314e-07 -0.09958720051665934 -2.0344 0.7063774912658206 0.7063762935763873 1.3800105488903647e-07 -0.09958732565870368 -2.0345 0.7063777146023262 0.7063765130069304 1.387809554671826e-07 -0.09958745076288905 -2.0346 0.7063779378796369 0.70637673236258 1.3951874686113364e-07 -0.09958757582922684 -2.0347 0.706378161097319 0.7063769516438105 1.4021427179738977e-07 -0.0995877008577285 -2.0348 0.7063783842549374 0.7063771708510975 1.408673828071083e-07 -0.09958782584840539 -2.0349 0.7063786073520552 0.706377389984918 1.4147794221222587e-07 -0.0995879508012689 -2.035 0.7063788303882346 0.7063776090457504 1.4204582217750006e-07 -0.09958807571633048 -2.0351000000000004 0.7063790533630364 0.7063778280340748 1.425709047486734e-07 -0.0995882005936015 -2.0352 0.7063792762760203 0.7063780469503718 1.4305308184553445e-07 -0.09958832543309336 -2.0353000000000003 0.7063794991267441 0.7063782657951232 1.4349225531742893e-07 -0.09958845023481736 -2.0354 0.7063797219147663 0.7063784845688119 1.4388833692591252e-07 -0.09958857499878497 -2.0355 0.706379944639643 0.7063787032719215 1.4424124839332308e-07 -0.09958869972500752 -2.0356 0.7063801673009305 0.7063789219049366 1.4455092141665848e-07 -0.09958882441349637 -2.0357 0.7063803898981842 0.7063791404683417 1.4481729765022933e-07 -0.09958894906426292 -2.0358 0.7063806124309587 0.7063793589626224 1.450403287438229e-07 -0.09958907367731852 -2.0359000000000003 0.7063808348988089 0.7063795773882646 1.4521997636005035e-07 -0.0995891982526745 -2.036 0.7063810573012888 0.7063797957457545 1.4535621214659122e-07 -0.09958932279034226 -2.0361000000000002 0.7063812796379526 0.7063800140355782 1.4544901776394892e-07 -0.09958944729033316 -2.0362 0.7063815019083541 0.706380232258222 1.4549838487851185e-07 -0.0995895717526585 -2.0363 0.7063817241120471 0.7063804504141725 1.4550431515561457e-07 -0.09958969617732966 -2.0364 0.7063819462485861 0.7063806685039158 1.454668202734155e-07 -0.099589820564358 -2.0365 0.7063821683175253 0.7063808865279373 1.4538592190208033e-07 -0.09958994491375484 -2.0366 0.7063823903184194 0.7063811044867232 1.4526165169337357e-07 -0.09959006922553154 -2.0367 0.7063826122508234 0.7063813223807583 1.450940512980059e-07 -0.09959019349969939 -2.0368000000000004 0.7063828341142934 0.7063815402105273 1.4488317232400072e-07 -0.09959031773626978 -2.0369 0.7063830559083853 0.7063817579765137 1.4462907630893862e-07 -0.09959044193525399 -2.037 0.7063832776326568 0.7063819756792007 1.4433183475812128e-07 -0.09959056609666335 -2.0371 0.7063834992866656 0.7063821933190706 1.439915290578353e-07 -0.09959069022050923 -2.0372 0.7063837208699706 0.7063824108966044 1.4360825053780224e-07 -0.0995908143068029 -2.0373 0.7063839423821321 0.7063826284122822 1.431821003358702e-07 -0.09959093835555569 -2.0374 0.7063841638227117 0.7063828458665825 1.4271318946740275e-07 -0.09959106236677889 -2.0375 0.7063843851912718 0.7063830632599831 1.4220163875588998e-07 -0.09959118634048382 -2.0376000000000003 0.7063846064873764 0.7063832805929601 1.4164757881213186e-07 -0.09959131027668179 -2.0377 0.7063848277105915 0.7063834978659878 1.4105114999260482e-07 -0.09959143417538413 -2.0378000000000003 0.7063850488604837 0.7063837150795396 1.4041250236129788e-07 -0.09959155803660212 -2.0379 0.7063852699366222 0.7063839322340859 1.3973179567930427e-07 -0.09959168186034699 -2.038 0.7063854909385778 0.7063841493300969 1.390091993319631e-07 -0.09959180564663012 -2.0381 0.7063857118659234 0.7063843663680394 1.382448922941648e-07 -0.09959192939546278 -2.0382000000000002 0.706385932718233 0.7063845833483791 1.3743906310259568e-07 -0.0995920531068562 -2.0383 0.706386153495084 0.7063848002715787 1.3659190981063496e-07 -0.0995921767808217 -2.0384 0.7063863741960555 0.7063850171380996 1.3570363990508816e-07 -0.09959230041737056 -2.0385 0.7063865948207286 0.7063852339484005 1.3477447029924816e-07 -0.09959242401651404 -2.0386 0.7063868153686874 0.7063854507029371 1.3380462725309794e-07 -0.09959254757826341 -2.0387 0.7063870358395183 0.7063856674021634 1.327943463247383e-07 -0.09959267110262995 -2.0388 0.7063872562328102 0.70638588404653 1.3174387231834617e-07 -0.09959279458962492 -2.0389 0.7063874765481548 0.7063861006364854 1.3065345920784677e-07 -0.09959291803925956 -2.039 0.7063876967851468 0.7063863171724751 1.2952337010221915e-07 -0.09959304145154513 -2.0391000000000004 0.7063879169433838 0.7063865336549412 1.2835387717610725e-07 -0.09959316482649291 -2.0392 0.7063881370224663 0.7063867500843233 1.2714526155879757e-07 -0.09959328816411417 -2.0393000000000003 0.7063883570219979 0.7063869664610574 1.258978133619748e-07 -0.09959341146442009 -2.0394 0.7063885769415855 0.7063871827855767 1.2461183151318833e-07 -0.09959353472742194 -2.0395 0.7063887967808394 0.706387399058311 1.2328762374197444e-07 -0.09959365795313102 -2.0396 0.7063890165393732 0.7063876152796863 1.219255064723035e-07 -0.09959378114155845 -2.0397 0.7063892362168038 0.7063878314501256 1.205258047705382e-07 -0.09959390429271553 -2.0398 0.7063894558127521 0.7063880475700482 1.1908885226563637e-07 -0.09959402740661351 -2.0399000000000003 0.7063896753268425 0.7063882636398693 1.1761499106588413e-07 -0.0995941504832636 -2.04 0.7063898947587031 0.706388479660001 1.1610457167909871e-07 -0.09959427352267704 -2.0401000000000002 0.7063901141079658 0.7063886956308507 1.1455795291895332e-07 -0.09959439652486501 -2.0402 0.7063903333742663 0.7063889115528226 1.129755018321188e-07 -0.09959451948983875 -2.0403000000000002 0.7063905525572451 0.7063891274263161 1.1135759361152742e-07 -0.09959464241760946 -2.0404 0.706390771656546 0.7063893432517274 1.097046114922895e-07 -0.09959476530818837 -2.0405 0.7063909906718173 0.7063895590294479 1.0801694668924333e-07 -0.09959488816158667 -2.0406 0.7063912096027114 0.7063897747598644 1.0629499827205513e-07 -0.09959501097781553 -2.0407 0.7063914284488857 0.7063899904433601 1.0453917307848282e-07 -0.09959513375688621 -2.0408000000000004 0.7063916472100016 0.7063902060803132 1.02749885651926e-07 -0.0995952564988099 -2.0409 0.7063918658857247 0.7063904216710973 1.0092755809570919e-07 -0.09959537920359778 -2.041 0.7063920844757257 0.7063906372160818 9.907262000716233e-08 -0.099595501871261 -2.0411 0.7063923029796799 0.7063908527156311 9.7185508363129e-08 -0.09959562450181081 -2.0412 0.7063925213972673 0.7063910681701047 9.526666742629142e-08 -0.09959574709525833 -2.0413 0.7063927397281731 0.7063912835798575 9.331654861333138e-08 -0.09959586965161482 -2.0414 0.7063929579720867 0.7063914989452396 9.133561042554139e-08 -0.09959599217089142 -2.0415 0.7063931761287031 0.7063917142665956 8.932431832392451e-08 -0.09959611465309931 -2.0416000000000003 0.7063933941977221 0.706391929544265 8.728314460776376e-08 -0.09959623709824958 -2.0417 0.7063936121788488 0.7063921447785826 8.521256833135538e-08 -0.09959635950635344 -2.0418000000000003 0.7063938300717933 0.7063923599698778 8.311307517043509e-08 -0.09959648187742208 -2.0419 0.7063940478762714 0.706392575118475 8.098515730595168e-08 -0.09959660421146665 -2.042 0.7063942655920038 0.7063927902246927 7.882931333386134e-08 -0.09959672650849834 -2.0421 0.7063944832187171 0.7063930052888439 7.664604811941089e-08 -0.09959684876852826 -2.0422000000000002 0.7063947007561429 0.7063932203112364 7.44358726999933e-08 -0.09959697099156754 -2.0423 0.7063949182040183 0.7063934352921728 7.219930415677811e-08 -0.09959709317762738 -2.0424 0.706395135562087 0.7063936502319496 6.99368654846072e-08 -0.09959721532671893 -2.0425 0.7063953528300972 0.7063938651308572 6.764908549138082e-08 -0.0995973374388533 -2.0426 0.7063955700078033 0.7063940799891812 6.533649865234081e-08 -0.09959745951404161 -2.0427 0.7063957870949653 0.7063942948072011 6.299964500425248e-08 -0.09959758155229502 -2.0428 0.7063960040913496 0.7063945095851898 6.063907000142255e-08 -0.09959770355362464 -2.0429 0.7063962209967283 0.7063947243234152 5.8255324409881015e-08 -0.09959782551804165 -2.043 0.7063964378108789 0.7063949390221387 5.584896415472551e-08 -0.09959794744555711 -2.0431 0.7063966545335856 0.7063951536816158 5.342055021256842e-08 -0.09959806933618216 -2.0432 0.7063968711646385 0.7063953683020961 5.097064846061594e-08 -0.09959819118992795 -2.0433000000000003 0.7063970877038335 0.7063955828838226 4.849982956391108e-08 -0.09959831300680552 -2.0434 0.7063973041509731 0.7063957974270327 4.60086688330863e-08 -0.09959843478682603 -2.0435 0.7063975205058659 0.7063960119319571 4.349774608385093e-08 -0.09959855653000058 -2.0436 0.7063977367683265 0.7063962263988203 4.096764551382581e-08 -0.09959867823634022 -2.0437 0.7063979529381761 0.7063964408278406 3.841895556029595e-08 -0.09959879990585609 -2.0438 0.7063981690152425 0.70639665521923 3.585226877010628e-08 -0.09959892153855932 -2.0439000000000003 0.7063983849993593 0.7063968695731939 3.32681816574143e-08 -0.09959904313446093 -2.044 0.7063986008903669 0.7063970838899314 3.0667294557973346e-08 -0.09959916469357208 -2.0441000000000003 0.7063988166881123 0.7063972981696349 2.8050211502497757e-08 -0.09959928621590386 -2.0442 0.706399032392449 0.7063975124124905 2.541754006747665e-08 -0.0995994077014673 -2.0443000000000002 0.7063992480032365 0.7063977266186775 2.2769891241600226e-08 -0.09959952915027351 -2.0444 0.7063994635203417 0.7063979407883689 2.010787926789992e-08 -0.09959965056233361 -2.0445 0.7063996789436373 0.7063981549217309 1.743212152925666e-08 -0.0995997719376586 -2.0446 0.7063998942730034 0.7063983690189226 1.4743238380132695e-08 -0.09959989327625957 -2.0447 0.7064001095083265 0.706398583080097 1.2041853012997872e-08 -0.09960001457814761 -2.0448000000000004 0.7064003246494998 0.7063987971054004 9.3285913143476e-09 -0.09960013584333377 -2.0449 0.706400539696423 0.706399011094972 6.6040817163839916e-09 -0.09960025707182912 -2.045 0.7064007546490028 0.7063992250489441 3.868955051299083e-09 -0.09960037826364465 -2.0451 0.7064009695071529 0.7063994389674428 1.123844412496966e-09 -0.0996004994187915 -2.0452 0.7064011842707933 0.7063996528505867 -1.6306149989292473e-09 -0.09960062053728062 -2.0453 0.7064013989398515 0.7063998666984883 -4.393786020781554e-09 -0.09960074161912319 -2.0454 0.7064016135142615 0.7064000805112527 -7.1650296737391095e-09 -0.09960086266433016 -2.0455 0.7064018279939639 0.7064002942889778 -9.943705313146534e-09 -0.09960098367291263 -2.0456000000000003 0.7064020423789068 0.7064005080317552 -1.272917076996019e-08 -0.09960110464488157 -2.0457 0.7064022566690445 0.7064007217396698 -1.552078250947539e-08 -0.0996012255802481 -2.0458000000000003 0.7064024708643388 0.7064009354127988 -1.83178957714053e-08 -0.09960134647902318 -2.0459 0.7064026849647583 0.706401149051213 -2.1119864721235587e-08 -0.09960146734121787 -2.046 0.7064028989702784 0.706401362654976 -2.3926042604181103e-08 -0.0996015881668432 -2.0461 0.7064031128808814 0.7064015762241445 -2.6735781883530096e-08 -0.09960170895591018 -2.0462000000000002 0.7064033266965564 0.706401789758768 -2.9548434401756654e-08 -0.09960182970842973 -2.0463 0.7064035404173 0.7064020032588897 -3.236335152125014e-08 -0.09960195042441301 -2.0464 0.7064037540431154 0.7064022167245454 -3.517988427957294e-08 -0.09960207110387098 -2.0465 0.706403967574013 0.7064024301557639 -3.799738353463516e-08 -0.09960219174681466 -2.0466 0.7064041810100097 0.706402643552567 -4.0815200118163395e-08 -0.09960231235325501 -2.0467 0.7064043943511298 0.7064028569149698 -4.363268498252886e-08 -0.09960243292320309 -2.0468 0.7064046075974042 0.70640307024298 -4.644918935155988e-08 -0.09960255345666984 -2.0469 0.7064048207488713 0.7064032835365988 -4.926406486937575e-08 -0.09960267395366627 -2.047 0.7064050338055758 0.7064034967958199 -5.207666374897665e-08 -0.09960279441420342 -2.0471 0.7064052467675699 0.7064037100206308 -5.4886338921294325e-08 -0.09960291483829224 -2.0472 0.7064054596349117 0.7064039232110113 -5.769244418719725e-08 -0.09960303522594365 -2.0473000000000003 0.7064056724076677 0.7064041363669347 -6.049433436084925e-08 -0.09960315557716867 -2.0474 0.7064058850859104 0.7064043494883671 -6.329136542073885e-08 -0.0996032758919783 -2.0475 0.7064060976697195 0.7064045625752682 -6.60828946598413e-08 -0.09960339617038355 -2.0476 0.7064063101591814 0.7064047756275903 -6.88682808285164e-08 -0.09960351641239534 -2.0477 0.7064065225543894 0.7064049886452792 -7.164688428391158e-08 -0.09960363661802468 -2.0478 0.7064067348554437 0.7064052016282736 -7.44180671395818e-08 -0.09960375678728253 -2.0479000000000003 0.7064069470624509 0.7064054145765055 -7.718119340860419e-08 -0.09960387692017979 -2.048 0.706407159175525 0.7064056274899 -7.993562914799385e-08 -0.09960399701672747 -2.0481 0.7064073711947865 0.7064058403683751 -8.268074260745634e-08 -0.09960411707693646 -2.0482000000000005 0.7064075831203627 0.7064060532118428 -8.541590437293606e-08 -0.09960423710081776 -2.0483000000000002 0.7064077949523875 0.7064062660202081 -8.814048751450143e-08 -0.09960435708838235 -2.0484 0.7064080066910017 0.7064064787933688 -9.085386772252069e-08 -0.0996044770396411 -2.0485 0.7064082183363525 0.7064066915312167 -9.355542345251128e-08 -0.09960459695460504 -2.0486 0.706408429888594 0.7064069042336365 -9.624453607779554e-08 -0.09960471683328503 -2.0487 0.7064086413478868 0.7064071169005065 -9.892059001266607e-08 -0.09960483667569209 -2.0488000000000004 0.7064088527143979 0.7064073295316986 -1.015829728711129e-07 -0.09960495648183709 -2.0489 0.7064090639883011 0.7064075421270777 -1.0423107559345834e-07 -0.09960507625173098 -2.049 0.7064092751697761 0.7064077546865022 -1.0686429259641056e-07 -0.09960519598538461 -2.0490999999999997 0.70640948625901 0.7064079672098246 -1.0948202190490253e-07 -0.099605315682809 -2.0492000000000004 0.7064096972561957 0.7064081796968908 -1.1208366529694147e-07 -0.09960543534401509 -2.0493 0.7064099081615324 0.70640839214754 -1.1466862842243741e-07 -0.09960555496901372 -2.0494 0.7064101189752259 0.7064086045616054 -1.1723632095499148e-07 -0.09960567455781583 -2.0495 0.7064103296974882 0.7064088169389133 -1.1978615673154114e-07 -0.09960579411043233 -2.0496 0.7064105403285375 0.706409029279285 -1.2231755386685195e-07 -0.09960591362687415 -2.0497 0.7064107508685977 0.7064092415825339 -1.2482993490096905e-07 -0.09960603310715213 -2.0498000000000003 0.7064109613178997 0.7064094538484689 -1.273227269327909e-07 -0.09960615255127715 -2.0499 0.7064111716766803 0.7064096660768915 -1.2979536173109152e-07 -0.0996062719592602 -2.05 0.7064113819451823 0.706409878267598 -1.3224727588891094e-07 -0.09960639133111214 -2.0501 0.7064115921236537 0.7064100904203787 -1.346779109363122e-07 -0.09960651066684388 -2.0502000000000002 0.7064118022123493 0.7064103025350175 -1.3708671346701617e-07 -0.09960662996646627 -2.0503 0.7064120122115296 0.7064105146112925 -1.3947313528064886e-07 -0.0996067492299902 -2.0504000000000002 0.7064122221214606 0.7064107266489761 -1.418366334833554e-07 -0.09960686845742653 -2.0505 0.7064124319424144 0.7064109386478348 -1.4417667062831263e-07 -0.09960698764878612 -2.0505999999999998 0.7064126416746687 0.7064111506076298 -1.4649271483542503e-07 -0.09960710680407986 -2.0507000000000004 0.7064128513185068 0.7064113625281163 -1.4878423990581646e-07 -0.0996072259233187 -2.0508 0.7064130608742176 0.7064115744090442 -1.510507254501997e-07 -0.09960734500651344 -2.0509 0.7064132703420957 0.7064117862501573 -1.5329165699816405e-07 -0.09960746405367497 -2.051 0.7064134797224405 0.7064119980511948 -1.5550652611613647e-07 -0.09960758306481414 -2.0511 0.7064136890155571 0.7064122098118893 -1.5769483053575117e-07 -0.09960770203994171 -2.0512 0.7064138982217565 0.7064124215319694 -1.598560742492594e-07 -0.09960782097906863 -2.0513000000000003 0.7064141073413541 0.7064126332111577 -1.619897676326948e-07 -0.09960793988220576 -2.0514 0.7064143163746708 0.7064128448491718 -1.6409542755689566e-07 -0.0996080587493639 -2.0515 0.7064145253220329 0.7064130564457242 -1.6617257748638425e-07 -0.09960817758055396 -2.0516 0.7064147341837712 0.7064132680005224 -1.6822074759732797e-07 -0.09960829637578673 -2.0517000000000003 0.7064149429602217 0.7064134795132688 -1.7023947488162272e-07 -0.09960841513507307 -2.0518 0.7064151516517252 0.7064136909836611 -1.7222830325444582e-07 -0.09960853385842378 -2.0519000000000003 0.7064153602586277 0.706413902411392 -1.7418678364966578e-07 -0.09960865254584972 -2.052 0.7064155687812793 0.7064141137961496 -1.7611447412912984e-07 -0.09960877119736172 -2.0521 0.706415777220035 0.706414325137617 -1.7801093997807382e-07 -0.09960888981297059 -2.0522000000000005 0.7064159855752548 0.7064145364354735 -1.7987575380573606e-07 -0.09960900839268717 -2.0523000000000002 0.7064161938473027 0.7064147476893932 -1.8170849561474633e-07 -0.09960912693652234 -2.0524 0.7064164020365467 0.7064149588990454 -1.835087529503121e-07 -0.09960924544448674 -2.0525 0.70641661014336 0.7064151700640964 -1.8527612096960744e-07 -0.09960936391659131 -2.0526 0.7064168181681197 0.7064153811842071 -1.8701020249381473e-07 -0.09960948235284682 -2.0527 0.7064170261112073 0.7064155922590347 -1.887106081573109e-07 -0.09960960075326411 -2.0528000000000004 0.7064172339730076 0.7064158032882323 -1.903769564388924e-07 -0.09960971911785398 -2.0529 0.7064174417539102 0.7064160142714488 -1.920088738074921e-07 -0.09960983744662719 -2.053 0.7064176494543082 0.7064162252083293 -1.9360599474993467e-07 -0.09960995573959454 -2.0530999999999997 0.7064178570745987 0.7064164360985152 -1.951679618854285e-07 -0.09961007399676686 -2.0532000000000004 0.7064180646151825 0.7064166469416442 -1.9669442604536291e-07 -0.0996101922181549 -2.0533 0.7064182720764641 0.7064168577373497 -1.9818504633922762e-07 -0.09961031040376953 -2.0534 0.7064184794588513 0.7064170684852624 -1.996394902205323e-07 -0.0996104285536214 -2.0535 0.7064186867627551 0.7064172791850087 -2.01057433583951e-07 -0.09961054666772129 -2.0536 0.7064188939885907 0.7064174898362124 -2.0243856081389455e-07 -0.09961066474608005 -2.0537 0.7064191011367764 0.7064177004384937 -2.0378256490594104e-07 -0.09961078278870845 -2.0538000000000003 0.7064193082077329 0.7064179109914694 -2.050891474494887e-07 -0.09961090079561725 -2.0539 0.7064195152018851 0.7064181214947538 -2.0635801878735038e-07 -0.09961101876681722 -2.054 0.7064197221196599 0.7064183319479573 -2.0758889800187585e-07 -0.09961113670231914 -2.0541 0.7064199289614876 0.7064185423506881 -2.0878151302250458e-07 -0.09961125460213371 -2.0542000000000002 0.7064201357278013 0.7064187527025514 -2.0993560068127692e-07 -0.09961137246627175 -2.0543 0.7064203424190366 0.7064189630031497 -2.1105090673018134e-07 -0.09961149029474398 -2.0544000000000002 0.706420549035632 0.7064191732520826 -2.121271859729934e-07 -0.09961160808756114 -2.0545 0.7064207555780284 0.7064193834489478 -2.1316420225139798e-07 -0.0996117258447341 -2.0545999999999998 0.7064209620466688 0.7064195935933396 -2.141617285213171e-07 -0.09961184356627344 -2.0547000000000004 0.7064211684419989 0.7064198036848507 -2.1511954690842106e-07 -0.0996119612521899 -2.0548 0.7064213747644666 0.7064200137230716 -2.1603744874282294e-07 -0.09961207890249435 -2.0549 0.7064215810145218 0.7064202237075905 -2.1691523461458972e-07 -0.09961219651719744 -2.055 0.7064217871926166 0.7064204336379933 -2.1775271441190625e-07 -0.09961231409630994 -2.0551 0.7064219932992046 0.7064206435138642 -2.1854970736617796e-07 -0.09961243163984254 -2.0552 0.7064221993347415 0.7064208533347858 -2.193060420763171e-07 -0.09961254914780594 -2.0553000000000003 0.706422405299685 0.7064210631003384 -2.200215565711927e-07 -0.09961266662021091 -2.0554 0.706422611194494 0.7064212728101014 -2.206960983269779e-07 -0.0996127840570682 -2.0555 0.7064228170196287 0.7064214824636521 -2.2132952430184427e-07 -0.09961290145838846 -2.0556 0.7064230227755515 0.7064216920605664 -2.2192170096371755e-07 -0.09961301882418239 -2.0557000000000003 0.7064232284627252 0.7064219016004193 -2.2247250431456367e-07 -0.09961313615446071 -2.0558 0.7064234340816147 0.7064221110827844 -2.229818199354916e-07 -0.09961325344923418 -2.0559000000000003 0.7064236396326853 0.7064223205072337 -2.2344954298675335e-07 -0.09961337070851344 -2.056 0.706423845116404 0.7064225298733393 -2.2387557824937732e-07 -0.09961348793230927 -2.0561 0.7064240505332375 0.706422739180671 -2.2425984012863776e-07 -0.09961360512063226 -2.0562000000000005 0.7064242558836547 0.7064229484287988 -2.246022526575242e-07 -0.09961372227349319 -2.0563000000000002 0.7064244611681243 0.7064231576172917 -2.2490274957306933e-07 -0.09961383939090267 -2.0564 0.7064246663871161 0.706423366745718 -2.2516127425736832e-07 -0.09961395647287148 -2.0565 0.7064248715411 0.7064235758136459 -2.2537777978615114e-07 -0.09961407351941028 -2.0566 0.706425076630546 0.7064237848206424 -2.2555222891143534e-07 -0.09961419053052967 -2.0567 0.7064252816559252 0.7064239937662751 -2.2568459410315933e-07 -0.0996143075062404 -2.0568 0.7064254866177084 0.7064242026501111 -2.25774857514488e-07 -0.09961442444655315 -2.0569 0.7064256915163667 0.706424411471717 -2.258230110199766e-07 -0.09961454135147861 -2.057 0.7064258963523704 0.70642462023066 -2.2582905617740678e-07 -0.09961465822102734 -2.0570999999999997 0.7064261011261908 0.706424828926507 -2.2579300425554227e-07 -0.09961477505521008 -2.0572000000000004 0.7064263058382979 0.7064250375588259 -2.2571487620290376e-07 -0.09961489185403752 -2.0573 0.706426510489162 0.7064252461271838 -2.2559470267205506e-07 -0.0996150086175202 -2.0574 0.7064267150792531 0.7064254546311493 -2.2543252397103086e-07 -0.09961512534566891 -2.0575 0.7064269196090398 0.7064256630702904 -2.252283900772145e-07 -0.09961524203849417 -2.0576 0.7064271240789909 0.706425871444177 -2.2498236061999077e-07 -0.09961535869600673 -2.0577 0.7064273284895738 0.7064260797523794 -2.246945048564597e-07 -0.0996154753182172 -2.0578000000000003 0.7064275328412559 0.706426287994468 -2.243649016610283e-07 -0.09961559190513626 -2.0579 0.7064277371345027 0.7064264961700151 -2.239936394733688e-07 -0.09961570845677453 -2.058 0.7064279413697786 0.7064267042785931 -2.23580816346991e-07 -0.09961582497314253 -2.0581 0.7064281455475476 0.706426912319777 -2.2312653984515873e-07 -0.09961594145425107 -2.0582000000000003 0.7064283496682723 0.7064271202931414 -2.2263092705129828e-07 -0.09961605790011067 -2.0583 0.7064285537324131 0.7064273281982636 -2.220941045412428e-07 -0.09961617431073201 -2.0584000000000002 0.7064287577404298 0.7064275360347214 -2.215162083485378e-07 -0.09961629068612565 -2.0585 0.7064289616927802 0.7064277438020947 -2.2089738391239955e-07 -0.09961640702630226 -2.0585999999999998 0.7064291655899206 0.7064279514999654 -2.2023778607077604e-07 -0.09961652333127247 -2.0587000000000004 0.7064293694323055 0.7064281591279162 -2.195375789944276e-07 -0.09961663960104687 -2.0588 0.7064295732203871 0.7064283666855324 -2.1879693615570184e-07 -0.09961675583563603 -2.0589 0.7064297769546162 0.7064285741724012 -2.180160402973086e-07 -0.09961687203505062 -2.059 0.7064299806354412 0.7064287815881116 -2.1719508338027826e-07 -0.0996169881993012 -2.0591 0.7064301842633084 0.7064289889322551 -2.1633426652845067e-07 -0.0996171043283984 -2.0592 0.7064303878386619 0.7064291962044251 -2.1543379997990275e-07 -0.09961722042235277 -2.0593000000000004 0.7064305913619431 0.7064294034042177 -2.1449390305225413e-07 -0.09961733648117496 -2.0594 0.7064307948335914 0.7064296105312311 -2.135148040836865e-07 -0.09961745250487553 -2.0595 0.7064309982540434 0.7064298175850666 -2.1249674035314636e-07 -0.09961756849346508 -2.0596 0.7064312016237331 0.7064300245653274 -2.1143995806993665e-07 -0.09961768444695418 -2.0597000000000003 0.7064314049430915 0.7064302314716202 -2.1034471226269447e-07 -0.0996178003653534 -2.0598 0.7064316082125472 0.706430438303554 -2.0921126674122714e-07 -0.09961791624867336 -2.0599000000000003 0.7064318114325254 0.7064306450607412 -2.0803989406181778e-07 -0.09961803209692464 -2.06 0.7064320146034483 0.7064308517427969 -2.0683087541273348e-07 -0.09961814791011775 -2.0601 0.7064322177257354 0.706431058349339 -2.0558450056565314e-07 -0.09961826368826329 -2.0602000000000005 0.7064324207998027 0.7064312648799895 -2.0430106782709512e-07 -0.09961837943137188 -2.0603000000000002 0.706432623826063 0.7064314713343732 -2.0298088393780334e-07 -0.09961849513945403 -2.0604 0.706432826804925 0.7064316777121178 -2.016242640172361e-07 -0.09961861081252027 -2.0605 0.7064330297367951 0.7064318840128554 -2.0023153147682993e-07 -0.09961872645058119 -2.0606 0.7064332326220752 0.706432090236221 -1.9880301795061062e-07 -0.09961884205364738 -2.0607 0.7064334354611641 0.7064322963818535 -1.9733906320845707e-07 -0.0996189576217293 -2.0608 0.7064336382544565 0.7064325024493954 -1.9584001509712068e-07 -0.09961907315483755 -2.0609 0.7064338410023433 0.7064327084384936 -1.943062294257336e-07 -0.0996191886529827 -2.061 0.7064340437052115 0.706432914348798 -1.9273806991029763e-07 -0.09961930411617521 -2.0610999999999997 0.7064342463634443 0.7064331201799632 -1.9113590805919234e-07 -0.09961941954442571 -2.0612000000000004 0.7064344489774204 0.7064333259316473 -1.8950012311419462e-07 -0.09961953493774461 -2.0613 0.7064346515475148 0.7064335316035135 -1.8783110193598684e-07 -0.09961965029614259 -2.0614 0.7064348540740983 0.7064337371952283 -1.8612923894170685e-07 -0.09961976561963012 -2.0615 0.7064350565575367 0.7064339427064628 -1.8439493597310896e-07 -0.0996198809082177 -2.0616 0.7064352589981917 0.7064341481368924 -1.8262860223758337e-07 -0.09961999616191583 -2.0617 0.7064354613964211 0.7064343534861974 -1.8083065420407274e-07 -0.09962011138073508 -2.0618000000000003 0.7064356637525773 0.7064345587540624 -1.79001515485111e-07 -0.09962022656468597 -2.0619 0.706435866067008 0.7064347639401766 -1.7714161675008722e-07 -0.09962034171377898 -2.062 0.7064360683400575 0.7064349690442338 -1.7525139563157044e-07 -0.09962045682802466 -2.0621 0.7064362705720639 0.7064351740659326 -1.7333129659694024e-07 -0.09962057190743345 -2.0622000000000003 0.7064364727633607 0.7064353790049767 -1.7138177089461026e-07 -0.09962068695201591 -2.0623 0.706436674914277 0.7064355838610745 -1.6940327638055586e-07 -0.09962080196178248 -2.0624000000000002 0.7064368770251366 0.7064357886339392 -1.6739627747147656e-07 -0.09962091693674367 -2.0625 0.706437079096258 0.7064359933232898 -1.6536124499907934e-07 -0.09962103187691 -2.0625999999999998 0.7064372811279551 0.7064361979288494 -1.632986561094646e-07 -0.09962114678229196 -2.0627000000000004 0.7064374831205363 0.7064364024503471 -1.6120899415557333e-07 -0.09962126165290004 -2.0628 0.7064376850743046 0.7064366068875172 -1.5909274857922595e-07 -0.09962137648874471 -2.0629 0.706437886989558 0.7064368112400987 -1.569504148018347e-07 -0.0996214912898365 -2.063 0.7064380888665887 0.7064370155078366 -1.5478249409603406e-07 -0.09962160605618575 -2.0631 0.7064382907056836 0.7064372196904809 -1.5258949349027107e-07 -0.09962172078780311 -2.0632 0.7064384925071243 0.7064374237877877 -1.5037192563002733e-07 -0.09962183548469895 -2.0633000000000004 0.7064386942711867 0.7064376277995184 -1.4813030866506205e-07 -0.0996219501468838 -2.0634 0.7064388959981407 0.7064378317254392 -1.4586516612971612e-07 -0.09962206477436804 -2.0635 0.7064390976882511 0.706438035565323 -1.4357702682321616e-07 -0.09962217936716217 -2.0636 0.7064392993417765 0.7064382393189486 -1.4126642468650918e-07 -0.09962229392527665 -2.0637000000000003 0.7064395009589698 0.7064384429860995 -1.3893389865654582e-07 -0.09962240844872189 -2.0638 0.7064397025400784 0.7064386465665657 -1.3657999258301357e-07 -0.09962252293750837 -2.0639000000000003 0.7064399040853433 0.7064388500601437 -1.3420525505833392e-07 -0.0996226373916466 -2.064 0.7064401055950003 0.7064390534666345 -1.318102393101095e-07 -0.09962275181114696 -2.0641 0.706440307069278 0.7064392567858465 -1.2939550307448922e-07 -0.09962286619601991 -2.0642000000000005 0.7064405085084 0.7064394600175934 -1.2696160846953353e-07 -0.09962298054627597 -2.0643000000000002 0.7064407099125836 0.7064396631616949 -1.2450912183908924e-07 -0.09962309486192547 -2.0644 0.7064409112820393 0.7064398662179769 -1.2203861365391033e-07 -0.09962320914297886 -2.0645 0.7064411126169723 0.706440069186272 -1.1955065836594114e-07 -0.09962332338944657 -2.0646 0.7064413139175814 0.7064402720664182 -1.170458342678038e-07 -0.09962343760133908 -2.0647 0.7064415151840584 0.7064404748582602 -1.1452472336616337e-07 -0.09962355177866675 -2.0648 0.7064417164165899 0.7064406775616492 -1.119879112394806e-07 -0.09962366592144006 -2.0649 0.7064419176153554 0.7064408801764421 -1.0943598691658118e-07 -0.09962378002966937 -2.065 0.7064421187805279 0.7064410827025027 -1.0686954271532656e-07 -0.0996238941033651 -2.0650999999999997 0.7064423199122749 0.7064412851397008 -1.0428917413592836e-07 -0.09962400814253769 -2.0652000000000004 0.7064425210107568 0.7064414874879132 -1.0169547970222126e-07 -0.09962412214719756 -2.0653 0.7064427220761273 0.7064416897470223 -9.908906082028296e-08 -0.09962423611735505 -2.0654 0.7064429231085346 0.7064418919169175 -9.647052165526887e-08 -0.09962435005302062 -2.0655 0.7064431241081193 0.7064420939974954 -9.384046897788906e-08 -0.0996244639542047 -2.0656 0.7064433250750162 0.7064422959886576 -9.119951203256926e-08 -0.09962457782091766 -2.0657 0.7064435260093527 0.7064424978903133 -8.85482623926015e-08 -0.09962469165316984 -2.0658000000000003 0.7064437269112506 0.7064426997023783 -8.588733381442726e-08 -0.09962480545097169 -2.0659 0.7064439277808243 0.7064429014247745 -8.321734210579856e-08 -0.09962491921433361 -2.066 0.7064441286181822 0.7064431030574305 -8.053890496618338e-08 -0.09962503294326588 -2.0661 0.7064443294234253 0.706443304600282 -7.785264186967178e-08 -0.09962514663777897 -2.0662000000000003 0.7064445301966485 0.7064435060532712 -7.515917390017723e-08 -0.09962526029788324 -2.0663 0.70644473093794 0.7064437074163464 -7.245912360962295e-08 -0.09962537392358904 -2.0664000000000002 0.7064449316473808 0.7064439086894636 -6.975311488653657e-08 -0.09962548751490674 -2.0665 0.7064451323250458 0.7064441098725847 -6.704177280209347e-08 -0.09962560107184676 -2.0665999999999998 0.706445332971003 0.7064443109656784 -6.43257234665684e-08 -0.09962571459441939 -2.0667000000000004 0.7064455335853133 0.7064445119687206 -6.160559389099124e-08 -0.09962582808263505 -2.0668 0.706445734168031 0.706444712881694 -5.8882011834925085e-08 -0.09962594153650413 -2.0669 0.7064459347192041 0.7064449137045872 -5.615560566378519e-08 -0.09962605495603692 -2.067 0.7064461352388733 0.706445114437396 -5.3427004209193746e-08 -0.09962616834124377 -2.0671 0.7064463357270732 0.7064453150801232 -5.069683661567369e-08 -0.09962628169213511 -2.0672 0.7064465361838306 0.706445515632778 -4.7965732202955025e-08 -0.0996263950087212 -2.0673000000000004 0.7064467366091665 0.7064457160953765 -4.5234320314566e-08 -0.09962650829101244 -2.0674 0.7064469370030944 0.7064459164679417 -4.250323017821497e-08 -0.09962662153901913 -2.0675 0.7064471373656216 0.706446116750503 -3.9773090757796786e-08 -0.09962673475275159 -2.0676 0.7064473376967484 0.7064463169430963 -3.7044530610359436e-08 -0.09962684793222017 -2.0677000000000003 0.7064475379964685 0.7064465170457654 -3.431817773903202e-08 -0.09962696107743524 -2.0678 0.7064477382647688 0.7064467170585597 -3.159465945313557e-08 -0.09962707418840708 -2.0679000000000003 0.7064479385016293 0.7064469169815357 -2.8874602217045242e-08 -0.09962718726514602 -2.068 0.7064481387070239 0.7064471168147568 -2.6158631512415362e-08 -0.09962730030766248 -2.0681 0.7064483388809191 0.7064473165582925 -2.344737169137842e-08 -0.09962741331596665 -2.0682000000000005 0.7064485390232746 0.7064475162122197 -2.0741445834297767e-08 -0.09962752629006894 -2.0683000000000002 0.7064487391340442 0.7064477157766217 -1.8041475605568708e-08 -0.0996276392299796 -2.0684 0.7064489392131741 0.706447915251588 -1.5348081110720668e-08 -0.09962775213570893 -2.0685 0.7064491392606049 0.7064481146372154 -1.2661880755687749e-08 -0.09962786500726727 -2.0686 0.7064493392762696 0.706448313933607 -9.98349110065827e-09 -0.09962797784466493 -2.0687 0.7064495392600953 0.7064485131408723 -7.313526725200026e-09 -0.09962809064791217 -2.0688 0.7064497392120022 0.7064487122591279 -4.652600083844549e-09 -0.0996282034170193 -2.0689 0.7064499391319039 0.7064489112884964 -2.001321367309239e-09 -0.09962831615199663 -2.069 0.7064501390197077 0.7064491102291071 6.397016458214999e-10 -0.09962842885285444 -2.0690999999999997 0.7064503388753144 0.7064493090810959 3.2698637165984312e-09 -0.09962854151960306 -2.0692000000000004 0.7064505386986182 0.7064495078446049 5.888562289689536e-09 -0.0996286541522527 -2.0693 0.7064507384895067 0.7064497065197831 8.495197630423168e-09 -0.09962876675081368 -2.0694 0.7064509382478616 0.7064499051067855 1.108917296356593e-08 -0.0996288793152963 -2.0695 0.7064511379735576 0.7064501036057736 1.366989461036583e-08 -0.09962899184571083 -2.0696 0.7064513376664635 0.706450302016915 1.62367721195239e-08 -0.09962910434206754 -2.0697 0.706451537326442 0.706450500340384 1.8789218412043618e-08 -0.0996292168043767 -2.0698000000000003 0.7064517369533485 0.7064506985763608 2.1326649899192085e-08 -0.09962932923264853 -2.0699 0.7064519365470332 0.7064508967250318 2.384848663689043e-08 -0.09962944162689333 -2.07 0.7064521361073399 0.7064510947865899 2.6354152440205558e-08 -0.09962955398712134 -2.0701 0.7064523356341061 0.7064512927612336 2.884307502386274e-08 -0.09962966631334282 -2.0702000000000003 0.7064525351271636 0.7064514906491683 3.131468612714572e-08 -0.09962977860556807 -2.0703 0.7064527345863371 0.7064516884506049 3.376842165614402e-08 -0.0996298908638073 -2.0704000000000002 0.7064529340114465 0.7064518861657603 3.6203721787836374e-08 -0.09963000308807078 -2.0705 0.7064531334023051 0.7064520837948571 3.862003113315471e-08 -0.09963011527836872 -2.0705999999999998 0.7064533327587204 0.7064522813381245 4.101679882718978e-08 -0.09963022743471138 -2.0707000000000004 0.7064535320804941 0.7064524787957971 4.339347868705101e-08 -0.099630339557109 -2.0708 0.706453731367422 0.7064526761681151 4.574952930554155e-08 -0.0996304516455718 -2.0709 0.7064539306192943 0.706452873455325 4.8084414202079206e-08 -0.09963056370011002 -2.071 0.7064541298358955 0.7064530706576787 5.039760192677989e-08 -0.09963067572073392 -2.0711 0.706454329017004 0.7064532677754336 5.268856618362294e-08 -0.0996307877074537 -2.0712 0.7064545281623933 0.706453464808853 5.49567859588207e-08 -0.09963089966027959 -2.0713000000000004 0.7064547272718309 0.7064536617582055 5.720174563184077e-08 -0.0996310115792218 -2.0714 0.7064549263450788 0.7064538586237648 5.9422935091632545e-08 -0.09963112346429051 -2.0715 0.706455125381894 0.7064540554058107 6.161984985979252e-08 -0.09963123531549603 -2.0716 0.7064553243820282 0.7064542521046284 6.379199119811718e-08 -0.09963134713284857 -2.0717000000000003 0.706455523345227 0.7064544487205076 6.59388662265642e-08 -0.09963145891635823 -2.0718 0.7064557222712313 0.7064546452537435 6.805998803600943e-08 -0.0996315706660353 -2.0719000000000003 0.7064559211597772 0.7064548417046368 7.015487578018731e-08 -0.09963168238188996 -2.072 0.7064561200105949 0.7064550380734929 7.222305481446867e-08 -0.09963179406393238 -2.0721 0.7064563188234103 0.7064552343606225 7.42640567930053e-08 -0.09963190571217279 -2.0722000000000005 0.706456517597944 0.7064554305663409 7.627741975720082e-08 -0.09963201732662133 -2.0723000000000003 0.7064567163339119 0.7064556266909687 7.826268825367189e-08 -0.09963212890728827 -2.0724 0.706456915031025 0.7064558227348309 8.021941344180106e-08 -0.09963224045418378 -2.0725 0.7064571136889894 0.7064560186982575 8.214715319782018e-08 -0.099632351967318 -2.0726 0.7064573123075069 0.7064562145815829 8.404547219460767e-08 -0.09963246344670114 -2.0727 0.7064575108862741 0.7064564103851465 8.591394201271085e-08 -0.09963257489234338 -2.0728 0.7064577094249838 0.7064566061092918 8.775214125136821e-08 -0.09963268630425488 -2.0729 0.7064579079233237 0.706456801754367 8.955965559095946e-08 -0.09963279768244583 -2.073 0.7064581063809778 0.7064569973207242 9.133607791964038e-08 -0.09963290902692637 -2.0730999999999997 0.7064583047976252 0.7064571928087204 9.308100839752753e-08 -0.09963302033770667 -2.0732000000000004 0.706458503172941 0.7064573882187164 9.479405455731227e-08 -0.09963313161479688 -2.0733 0.7064587015065965 0.7064575835510771 9.647483141528301e-08 -0.0996332428582072 -2.0734 0.7064588997982587 0.7064577788061718 9.812296150601973e-08 -0.09963335406794778 -2.0735 0.7064590980475906 0.7064579739843733 9.973807501076348e-08 -0.09963346524402875 -2.0736 0.7064592962542511 0.7064581690860585 1.0131980983721367e-07 -0.09963357638646028 -2.0737 0.7064594944178957 0.7064583641116085 1.0286781166810033e-07 -0.09963368749525253 -2.0738000000000003 0.7064596925381765 0.7064585590614068 1.043817340860842e-07 -0.09963379857041563 -2.0739 0.7064598906147408 0.706458753935842 1.058612386153901e-07 -0.09963390961195968 -2.074 0.7064600886472332 0.7064589487353053 1.0730599480160419e-07 -0.09963402061989486 -2.0741 0.7064602866352949 0.7064591434601919 1.087156803157574e-07 -0.09963413159423126 -2.0742000000000003 0.7064604845785638 0.7064593381108996 1.10089980982081e-07 -0.09963424253497905 -2.0743 0.706460682476674 0.7064595326878305 1.1142859088209e-07 -0.09963435344214838 -2.0744000000000002 0.7064608803292569 0.7064597271913888 1.1273121239968598e-07 -0.09963446431574936 -2.0745 0.7064610781359404 0.7064599216219829 1.139975563148321e-07 -0.0996345751557921 -2.0745999999999998 0.7064612758963498 0.7064601159800233 1.1522734183824768e-07 -0.09963468596228675 -2.0747000000000004 0.7064614736101069 0.7064603102659238 1.1642029667732756e-07 -0.09963479673524338 -2.0748 0.7064616712768317 0.7064605044801009 1.1757615712287839e-07 -0.09963490747467213 -2.0749 0.7064618688961403 0.7064606986229738 1.1869466808728246e-07 -0.09963501818058312 -2.075 0.7064620664676466 0.7064608926949643 1.1977558314960057e-07 -0.09963512885298643 -2.0751 0.7064622639909627 0.7064610866964969 1.2081866463536928e-07 -0.09963523949189218 -2.0752 0.7064624614656971 0.7064612806279982 1.2182368364782592e-07 -0.09963535009731044 -2.0753000000000004 0.7064626588914567 0.7064614744898979 1.2279042012688923e-07 -0.0996354606692514 -2.0754 0.7064628562678456 0.7064616682826272 1.237186628977316e-07 -0.09963557120772505 -2.0755 0.7064630535944665 0.7064618620066194 1.246082097297596e-07 -0.09963568171274156 -2.0756 0.7064632508709191 0.7064620556623105 1.2545886734355305e-07 -0.09963579218431098 -2.0757000000000003 0.706463448096802 0.7064622492501378 1.2627045148372318e-07 -0.09963590262244343 -2.0758 0.7064636452717112 0.706462442770541 1.270427869640156e-07 -0.09963601302714897 -2.0759000000000003 0.7064638423952413 0.7064626362239611 1.2777570766731028e-07 -0.09963612339843762 -2.076 0.7064640394669852 0.706462829610841 1.2846905662541874e-07 -0.09963623373631951 -2.0761 0.7064642364865343 0.7064630229316251 1.291226860294925e-07 -0.09963634404080468 -2.0762000000000005 0.7064644334534786 0.7064632161867597 1.297364572577786e-07 -0.09963645431190335 -2.0763000000000003 0.7064646303674063 0.7064634093766915 1.3031024090684462e-07 -0.09963656454962543 -2.0764 0.7064648272279045 0.7064636025018698 1.3084391683321206e-07 -0.09963667475398102 -2.0765 0.7064650240345594 0.7064637955627437 1.3133737416376468e-07 -0.09963678492498025 -2.0766 0.706465220786956 0.7064639885597641 1.3179051131309572e-07 -0.09963689506263308 -2.0767 0.706465417484678 0.7064641814933827 1.3220323604595796e-07 -0.09963700516694965 -2.0768 0.7064656141273084 0.7064643743640524 1.3257546542175258e-07 -0.09963711523793994 -2.0769 0.7064658107144295 0.7064645671722263 1.3290712589514309e-07 -0.09963722527561406 -2.077 0.7064660072456228 0.7064647599183587 1.331981532466664e-07 -0.099637335279982 -2.0770999999999997 0.7064662037204696 0.7064649526029041 1.3344849265906067e-07 -0.09963744525105385 -2.0772000000000004 0.7064664001385503 0.7064651452263178 1.3365809869297918e-07 -0.09963755518883967 -2.0773 0.706466596499445 0.7064653377890551 1.3382693531474588e-07 -0.09963766509334943 -2.0774 0.706466792802734 0.7064655302915718 1.339549759032943e-07 -0.09963777496459329 -2.0775 0.7064669890479962 0.7064657227343238 1.340422032154731e-07 -0.09963788480258114 -2.0776 0.7064671852348117 0.7064659151177669 1.340886094346183e-07 -0.09963799460732307 -2.0777 0.7064673813627601 0.7064661074423569 1.3409419613932827e-07 -0.09963810437882904 -2.0778000000000003 0.7064675774314211 0.70646629970855 1.3405897431734148e-07 -0.09963821411710919 -2.0779 0.706467773440375 0.7064664919168013 1.3398296434125045e-07 -0.09963832382217346 -2.078 0.7064679693892019 0.7064666840675666 1.3386619598584892e-07 -0.0996384334940319 -2.0781 0.7064681652774827 0.7064668761613003 1.337087083934374e-07 -0.09963854313269455 -2.0782000000000003 0.7064683611047984 0.7064670681984566 1.3351055008423152e-07 -0.09963865273817135 -2.0783 0.7064685568707312 0.7064672601794894 1.3327177893207587e-07 -0.09963876231047238 -2.0784000000000002 0.7064687525748636 0.7064674521048511 1.329924621540357e-07 -0.0996388718496076 -2.0785 0.7064689482167792 0.706467643974994 1.3267267628264134e-07 -0.09963898135558702 -2.0786 0.7064691437960624 0.7064678357903689 1.3231250712772424e-07 -0.09963909082842064 -2.0787000000000004 0.7064693393122989 0.7064680275514259 1.3191204980070315e-07 -0.09963920026811846 -2.0788 0.7064695347650749 0.7064682192586138 1.3147140866254237e-07 -0.09963930967469045 -2.0789 0.7064697301539786 0.7064684109123804 1.3099069728211843e-07 -0.09963941904814666 -2.079 0.7064699254785989 0.7064686025131719 1.304700384466284e-07 -0.099639528388497 -2.0791 0.7064701207385263 0.7064687940614333 1.2990956407485377e-07 -0.09963963769575152 -2.0792 0.7064703159333532 0.7064689855576077 1.2930941526573259e-07 -0.09963974696992017 -2.0793000000000004 0.7064705110626728 0.7064691770021372 1.2866974217692895e-07 -0.09963985621101294 -2.0794 0.7064707061260811 0.7064693683954613 1.2799070404218016e-07 -0.09963996541903981 -2.0795 0.7064709011231749 0.7064695597380184 1.2727246911231616e-07 -0.09964007459401072 -2.0796 0.7064710960535536 0.7064697510302447 1.2651521462403448e-07 -0.0996401837359357 -2.0797000000000003 0.7064712909168183 0.7064699422725742 1.2571912671663354e-07 -0.09964029284482462 -2.0798 0.7064714857125722 0.7064701334654393 1.2488440045976823e-07 -0.09964040192068756 -2.0799000000000003 0.706471680440421 0.7064703246092696 1.2401123974242756e-07 -0.09964051096353438 -2.08 0.7064718750999723 0.7064705157044929 1.2309985724517913e-07 -0.09964061997337513 -2.0801 0.7064720696908363 0.7064707067515343 1.2215047439506632e-07 -0.09964072895021969 -2.0802000000000005 0.7064722642126253 0.7064708977508164 1.2116332131356655e-07 -0.09964083789407802 -2.0803000000000003 0.7064724586649549 0.7064710887027594 1.2013863673679404e-07 -0.09964094680496006 -2.0804 0.7064726530474428 0.7064712796077806 1.1907666799468308e-07 -0.09964105568287582 -2.0805 0.7064728473597094 0.7064714704662949 1.1797767091384359e-07 -0.09964116452783517 -2.0806 0.7064730416013787 0.7064716612787139 1.1684190977245823e-07 -0.09964127333984812 -2.0807 0.7064732357720767 0.7064718520454465 1.156696572447713e-07 -0.09964138211892454 -2.0808 0.7064734298714328 0.7064720427668989 1.1446119433169977e-07 -0.09964149086507444 -2.0809 0.7064736238990799 0.7064722334434732 1.1321681029144437e-07 -0.09964159957830766 -2.081 0.7064738178546532 0.7064724240755693 1.1193680255622285e-07 -0.0996417082586342 -2.0810999999999997 0.7064740117377919 0.7064726146635832 1.106214766906366e-07 -0.09964181690606393 -2.0812000000000004 0.7064742055481386 0.706472805207908 1.0927114629799561e-07 -0.09964192552060681 -2.0813 0.7064743992853388 0.7064729957089328 1.0788613295439897e-07 -0.09964203410227274 -2.0814 0.7064745929490424 0.7064731861670432 1.0646676612199868e-07 -0.09964214265107164 -2.0815 0.706474786538902 0.706473376582622 1.0501338308308017e-07 -0.09964225116701346 -2.0816 0.7064749800545744 0.7064735669560471 1.0352632883944834e-07 -0.09964235965010805 -2.0817 0.7064751734957202 0.7064737572876932 1.0200595606732477e-07 -0.09964246810036533 -2.0818000000000003 0.7064753668620039 0.7064739475779312 1.004526250028559e-07 -0.09964257651779526 -2.0819 0.7064755601530937 0.7064741378271278 9.88667033588464e-08 -0.09964268490240766 -2.082 0.7064757533686616 0.7064743280356455 9.724856626577849e-08 -0.09964279325421244 -2.0821 0.7064759465083847 0.7064745182038432 9.559859613303412e-08 -0.09964290157321952 -2.0822000000000003 0.7064761395719437 0.7064747083320753 9.391718260379212e-08 -0.0996430098594388 -2.0823 0.7064763325590232 0.7064748984206919 9.22047224509448e-08 -0.0996431181128802 -2.0824000000000003 0.7064765254693127 0.7064750884700388 9.046161947648401e-08 -0.09964322633355355 -2.0825 0.7064767183025058 0.7064752784804573 8.868828441435661e-08 -0.09964333452146876 -2.0826 0.7064769110583008 0.7064754684522843 8.688513485760607e-08 -0.09964344267663566 -2.0827000000000004 0.7064771037364002 0.7064756583858521 8.505259511612517e-08 -0.09964355079906419 -2.0828 0.7064772963365116 0.7064758482814884 8.319109615767539e-08 -0.09964365888876418 -2.0829 0.7064774888583469 0.706476038139516 8.130107548819099e-08 -0.09964376694574552 -2.083 0.7064776813016234 0.7064762279602532 7.938297704596087e-08 -0.09964387497001809 -2.0831 0.7064778736660622 0.7064764177440133 7.743725111662714e-08 -0.09964398296159176 -2.0832 0.7064780659513905 0.7064766074911049 7.546435421001974e-08 -0.0996440909204764 -2.0833000000000004 0.7064782581573394 0.706476797201831 7.346474895260358e-08 -0.09964419884668185 -2.0834 0.7064784502836459 0.7064769868764901 7.143890398686459e-08 -0.09964430674021796 -2.0835 0.7064786423300512 0.7064771765153754 6.938729386549158e-08 -0.09964441460109456 -2.0836 0.7064788342963024 0.7064773661187753 6.7310398921272e-08 -0.09964452242932154 -2.0837000000000003 0.7064790261821517 0.7064775556869725 6.520870517862098e-08 -0.09964463022490876 -2.0838 0.7064792179873562 0.7064777452202444 6.308270422000772e-08 -0.099644737987866 -2.0839000000000003 0.7064794097116791 0.7064779347188634 6.093289309054561e-08 -0.09964484571820317 -2.084 0.7064796013548881 0.7064781241830964 5.8759774154010236e-08 -0.0996449534159301 -2.0841 0.7064797929167568 0.7064783136132045 5.6563855013042064e-08 -0.0996450610810566 -2.0842 0.7064799843970642 0.7064785030094438 5.434564835475608e-08 -0.09964516871359254 -2.0843000000000003 0.706480175795595 0.7064786923720644 5.210567185359727e-08 -0.09964527631354768 -2.0844 0.7064803671121394 0.7064788817013108 4.984444803950161e-08 -0.09964538388093187 -2.0845 0.7064805583464933 0.706479070997422 4.756250418166963e-08 -0.09964549141575499 -2.0846 0.7064807494984584 0.7064792602606316 4.526037216193157e-08 -0.09964559891802682 -2.0847 0.7064809405678419 0.7064794494911668 4.293858835505149e-08 -0.0996457063877572 -2.0848 0.7064811315544572 0.7064796386892493 4.059769350556186e-08 -0.09964581382495591 -2.0849 0.7064813224581231 0.7064798278550948 3.823823258204684e-08 -0.09964592122963278 -2.085 0.7064815132786646 0.7064800169889136 3.586075469387551e-08 -0.09964602860179765 -2.0850999999999997 0.7064817040159121 0.7064802060909091 3.34658129073212e-08 -0.09964613594146024 -2.0852000000000004 0.7064818946697031 0.7064803951612796 3.1053964160560055e-08 -0.09964624324863043 -2.0853 0.7064820852398801 0.706480584200217 2.862576912489312e-08 -0.099646350523318 -2.0854 0.7064822757262922 0.7064807732079071 2.6181792053825426e-08 -0.09964645776553277 -2.0855 0.7064824661287941 0.7064809621845297 2.3722600673778405e-08 -0.0996465649752845 -2.0856 0.7064826564472474 0.7064811511302583 2.124876604704673e-08 -0.09964667215258301 -2.0857 0.706482846681519 0.7064813400452608 1.876086243648989e-08 -0.09964677929743809 -2.0858000000000003 0.7064830368314825 0.7064815289296976 1.625946717022375e-08 -0.09964688640985953 -2.0859 0.7064832268970176 0.7064817177837244 1.3745160514118393e-08 -0.09964699348985706 -2.086 0.7064834168780101 0.7064819066074896 1.1218525534754942e-08 -0.09964710053744048 -2.0861 0.7064836067743526 0.7064820954011357 8.680147964117146e-09 -0.09964720755261962 -2.0862000000000003 0.7064837965859434 0.7064822841647986 6.1306160608134985e-09 -0.09964731453540415 -2.0863 0.7064839863126876 0.7064824728986087 3.570520475636163e-09 -0.09964742148580397 -2.0864000000000003 0.7064841759544966 0.7064826616026887 1.000454116252547e-09 -0.09964752840382879 -2.0865 0.7064843655112876 0.7064828502771561 -1.5789879863684075e-09 -0.09964763528948838 -2.0866 0.706484554982985 0.706483038922121 -4.1672088271424435e-09 -0.09964774214279246 -2.0867000000000004 0.7064847443695192 0.7064832275376877 -6.763609551770078e-09 -0.09964784896375083 -2.0868 0.7064849336708272 0.7064834161239539 -9.367589609392268e-09 -0.0996479557523732 -2.0869 0.7064851228868525 0.706483604681011 -1.1978546874021057e-08 -0.09964806250866945 -2.087 0.7064853120175446 0.7064837932089436 -1.4595877800231e-08 -0.0996481692326492 -2.0871 0.7064855010628603 0.7064839817078299 -1.7218977550661346e-08 -0.0996482759243223 -2.0872 0.7064856900227623 0.7064841701777417 -1.9847240145202255e-08 -0.0996483825836984 -2.0873000000000004 0.7064858788972197 0.7064843586187438 -2.2480058591966418e-08 -0.09964848921078726 -2.0874 0.7064860676862086 0.7064845470308954 -2.5116825035607915e-08 -0.09964859580559865 -2.0875 0.7064862563897114 0.706484735414248 -2.7756930892196968e-08 -0.09964870236814227 -2.0876 0.7064864450077174 0.706484923768848 -3.039976698994938e-08 -0.0996488088984279 -2.0877000000000003 0.7064866335402216 0.7064851120947337 -3.304472371407595e-08 -0.09964891539646525 -2.0878 0.7064868219872262 0.7064853003919382 -3.569119114165721e-08 -0.09964902186226408 -2.0879000000000003 0.7064870103487397 0.706485488660487 -3.83385591877939e-08 -0.09964912829583406 -2.088 0.7064871986247774 0.7064856769003995 -4.0986217739614333e-08 -0.09964923469718492 -2.0881 0.7064873868153612 0.7064858651116886 -4.363355680169303e-08 -0.09964934106632643 -2.0882 0.7064875749205186 0.7064860532943603 -4.6279966637295146e-08 -0.09964944740326818 -2.0883000000000003 0.7064877629402848 0.7064862414484147 -4.892483790438964e-08 -0.09964955370802003 -2.0884 0.7064879508747011 0.7064864295738448 -5.1567561800227625e-08 -0.0996496599805916 -2.0885 0.7064881387238153 0.7064866176706375 -5.4207530198304224e-08 -0.0996497662209927 -2.0886 0.7064883264876816 0.7064868057387726 -5.684413579057877e-08 -0.09964987242923291 -2.0887000000000002 0.7064885141663608 0.706486993778224 -5.9476772224517985e-08 -0.09964997860532204 -2.0888 0.7064887017599202 0.7064871817889584 -6.210483424490959e-08 -0.09965008474926967 -2.0889 0.7064888892684336 0.7064873697709368 -6.472771783101391e-08 -0.09965019086108559 -2.089 0.7064890766919811 0.7064875577241132 -6.734482033837752e-08 -0.09965029694077944 -2.0890999999999997 0.7064892640306495 0.7064877456484353 -6.995554063327428e-08 -0.09965040298836092 -2.0892000000000004 0.7064894512845321 0.7064879335438445 -7.25592792334348e-08 -0.09965050900383977 -2.0893 0.706489638453728 0.7064881214102756 -7.515543844422226e-08 -0.0996506149872256 -2.0894 0.7064898255383436 0.706488309247657 -7.774342250087968e-08 -0.09965072093852818 -2.0895 0.7064900125384908 0.7064884970559107 -8.032263769299636e-08 -0.09965082685775711 -2.0896 0.7064901994542881 0.7064886848349526 -8.28924925158625e-08 -0.0996509327449221 -2.0897 0.7064903862858609 0.706488872584692 -8.545239779233355e-08 -0.09965103860003278 -2.0898000000000003 0.7064905730333398 0.7064890603050319 -8.800176681724586e-08 -0.09965114442309886 -2.0899 0.7064907596968628 0.7064892479958693 -9.054001548925578e-08 -0.09965125021413002 -2.09 0.7064909462765734 0.7064894356570945 -9.306656244181116e-08 -0.09965135597313589 -2.0901 0.7064911327726213 0.7064896232885925 -9.55808291827967e-08 -0.09965146170012615 -2.0902000000000003 0.706491319185163 0.7064898108902409 -9.808224021769923e-08 -0.09965156739511041 -2.0903 0.7064915055143599 0.7064899984619117 -1.0057022319012038e-07 -0.09965167305809836 -2.0904000000000003 0.7064916917603812 0.7064901860034714 -1.0304420900841132e-07 -0.09965177868909966 -2.0905 0.7064918779234008 0.7064903735147794 -1.0550363197490975e-07 -0.09965188428812397 -2.0906 0.7064920640035991 0.7064905609956896 -1.0794792991517671e-07 -0.09965198985518087 -2.0907000000000004 0.7064922500011626 0.7064907484460502 -1.1037654430896826e-07 -0.09965209539028011 -2.0908 0.7064924359162834 0.7064909358657028 -1.1278892041513555e-07 -0.09965220089343124 -2.0909 0.70649262174916 0.7064911232544835 -1.1518450740780062e-07 -0.09965230636464395 -2.091 0.7064928074999963 0.706491310612222 -1.1756275848651132e-07 -0.09965241180392784 -2.0911 0.7064929931690025 0.7064914979387433 -1.1992313100374352e-07 -0.09965251721129259 -2.0912 0.7064931787563937 0.7064916852338654 -1.2226508660541369e-07 -0.09965262258674779 -2.0913000000000004 0.7064933642623916 0.7064918724974014 -1.2458809133843174e-07 -0.0996527279303031 -2.0914 0.7064935496872231 0.7064920597291582 -1.2689161576692753e-07 -0.09965283324196811 -2.0915 0.7064937350311209 0.7064922469289374 -1.2917513511102874e-07 -0.0996529385217524 -2.0916 0.706493920294323 0.7064924340965348 -1.3143812935441368e-07 -0.09965304376966566 -2.0917000000000003 0.7064941054770736 0.7064926212317404 -1.336800833588031e-07 -0.09965314898571742 -2.0918 0.7064942905796217 0.7064928083343399 -1.3590048700100332e-07 -0.09965325416991742 -2.0919 0.7064944756022217 0.7064929954041125 -1.3809883526311184e-07 -0.0996533593222752 -2.092 0.7064946605451339 0.706493182440832 -1.402746283608869e-07 -0.09965346444280036 -2.0921 0.7064948454086233 0.7064933694442674 -1.424273718669128e-07 -0.0996535695315025 -2.0922 0.7064950301929603 0.7064935564141823 -1.4455657680427503e-07 -0.0996536745883912 -2.0923000000000003 0.7064952148984209 0.7064937433503351 -1.4666175975931728e-07 -0.09965377961347609 -2.0924 0.7064953995252858 0.7064939302524789 -1.4874244301001094e-07 -0.09965388460676675 -2.0925 0.7064955840738408 0.706494117120362 -1.507981546057524e-07 -0.09965398956827283 -2.0926 0.7064957685443768 0.7064943039537277 -1.5282842850440626e-07 -0.09965409449800389 -2.0927000000000002 0.7064959529371895 0.7064944907523143 -1.548328046607761e-07 -0.09965419939596945 -2.0928 0.7064961372525791 0.706494677515855 -1.5681082913415745e-07 -0.09965430426217917 -2.0929 0.7064963214908515 0.7064948642440785 -1.5876205418374756e-07 -0.09965440909664258 -2.093 0.7064965056523165 0.7064950509367085 -1.6068603838140239e-07 -0.09965451389936925 -2.0930999999999997 0.7064966897372892 0.7064952375934646 -1.6258234670878113e-07 -0.09965461867036884 -2.0932000000000004 0.7064968737460885 0.7064954242140609 -1.6445055064581715e-07 -0.09965472340965081 -2.0933 0.7064970576790388 0.7064956107982079 -1.6629022829214857e-07 -0.09965482811722483 -2.0934 0.706497241536468 0.7064957973456112 -1.681009644260989e-07 -0.0996549327931004 -2.0935 0.7064974253187087 0.7064959838559717 -1.698823506347813e-07 -0.0996550374372871 -2.0936 0.7064976090260983 0.7064961703289867 -1.7163398537307917e-07 -0.09965514204979449 -2.0937 0.7064977926589775 0.7064963567643487 -1.7335547408334206e-07 -0.09965524663063208 -2.0938000000000003 0.7064979762176922 0.7064965431617465 -1.7504642925783576e-07 -0.09965535117980955 -2.0939 0.7064981597025912 0.7064967295208645 -1.7670647054976452e-07 -0.09965545569733636 -2.094 0.7064983431140284 0.7064969158413832 -1.7833522485480313e-07 -0.09965556018322207 -2.0941 0.7064985264523607 0.7064971021229789 -1.7993232637181222e-07 -0.09965566463747622 -2.0942000000000003 0.7064987097179491 0.7064972883653247 -1.8149741671386055e-07 -0.09965576906010834 -2.0943 0.7064988929111591 0.7064974745680894 -1.8303014497067505e-07 -0.099655873451128 -2.0944000000000003 0.7064990760323586 0.7064976607309383 -1.8453016777802977e-07 -0.09965597781054474 -2.0945 0.7064992590819199 0.706497846853533 -1.8599714943223766e-07 -0.09965608213836802 -2.0946 0.7064994420602191 0.7064980329355321 -1.8743076192831443e-07 -0.0996561864346075 -2.0947000000000005 0.7064996249676345 0.70649821897659 -1.8883068505712308e-07 -0.09965629069927262 -2.0948 0.706499807804549 0.7064984049763583 -1.9019660647129344e-07 -0.09965639493237294 -2.0949 0.706499990571348 0.706498590934485 -1.9152822171644712e-07 -0.09965649913391797 -2.095 0.7065001732684205 0.706498776850615 -1.928252343734449e-07 -0.09965660330391721 -2.0951 0.7065003558961582 0.7064989627243904 -1.9408735606532557e-07 -0.0996567074423802 -2.0952 0.7065005384549561 0.7064991485554499 -1.9531430653016435e-07 -0.09965681154931648 -2.0953000000000004 0.7065007209452117 0.7064993343434297 -1.965058137112785e-07 -0.0996569156247355 -2.0954 0.7065009033673257 0.7064995200879629 -1.9766161378498293e-07 -0.09965701966864682 -2.0955 0.7065010857217018 0.7064997057886797 -1.9878145123344848e-07 -0.09965712368105994 -2.0956 0.7065012680087452 0.706499891445208 -1.9986507891756045e-07 -0.0996572276619843 -2.0957000000000003 0.706501450228865 0.7065000770571731 -2.0091225809426572e-07 -0.09965733161142948 -2.0958 0.706501632382472 0.7065002626241977 -2.0192275849290064e-07 -0.09965743552940497 -2.0959 0.7065018144699791 0.7065004481459023 -2.0289635836723274e-07 -0.0996575394159202 -2.096 0.7065019964918025 0.7065006336219048 -2.0383284453015516e-07 -0.09965764327098475 -2.0961 0.7065021784483594 0.7065008190518214 -2.0473201241266725e-07 -0.09965774709460803 -2.0962 0.70650236034007 0.7065010044352656 -2.055936661124469e-07 -0.09965785088679957 -2.0963000000000003 0.7065025421673559 0.7065011897718495 -2.06417618421606e-07 -0.09965795464756887 -2.0964 0.7065027239306408 0.7065013750611829 -2.072036908683239e-07 -0.09965805837692537 -2.0965 0.7065029056303505 0.706501560302874 -2.0795171375501131e-07 -0.09965816207487856 -2.0966 0.7065030872669118 0.706501745496529 -2.0866152622422973e-07 -0.09965826574143791 -2.0967000000000002 0.7065032688407535 0.7065019306417526 -2.0933297625522207e-07 -0.09965836937661283 -2.0968 0.7065034503523064 0.7065021157381481 -2.0996592070554598e-07 -0.09965847298041289 -2.0969 0.706503631802002 0.7065023007853177 -2.1056022535964614e-07 -0.09965857655284752 -2.097 0.7065038131902734 0.7065024857828616 -2.111157649357931e-07 -0.09965868009392616 -2.0970999999999997 0.7065039945175552 0.706502670730379 -2.116324231069e-07 -0.09965878360365835 -2.0972000000000004 0.7065041757842825 0.7065028556274682 -2.121100925525643e-07 -0.09965888708205349 -2.0973 0.706504356990892 0.7065030404737259 -2.1254867497641494e-07 -0.09965899052912101 -2.0974 0.706504538137821 0.7065032252687484 -2.129480811061124e-07 -0.09965909394487038 -2.0975 0.7065047192255078 0.7065034100121308 -2.133082307072265e-07 -0.09965919732931106 -2.0976 0.7065049002543915 0.7065035947034679 -2.1362905263180854e-07 -0.09965930068245249 -2.0977 0.7065050812249117 0.7065037793423532 -2.1391048480798314e-07 -0.09965940400430412 -2.0978000000000003 0.7065052621375086 0.7065039639283803 -2.14152474246887e-07 -0.09965950729487538 -2.0979 0.706505442992623 0.7065041484611416 -2.1435497708083284e-07 -0.0996596105541757 -2.098 0.7065056237906957 0.7065043329402299 -2.1451795854596223e-07 -0.09965971378221453 -2.0981 0.7065058045321679 0.7065045173652371 -2.146413929822455e-07 -0.09965981697900128 -2.0982000000000003 0.7065059852174815 0.7065047017357556 -2.1472526385429846e-07 -0.09965992014454543 -2.0983 0.7065061658470777 0.706504886051377 -2.1476956374444356e-07 -0.09966002327885637 -2.0984000000000003 0.7065063464213981 0.7065050703116936 -2.1477429435617923e-07 -0.09966012638194355 -2.0985 0.7065065269408838 0.7065052545162973 -2.1473946651071052e-07 -0.09966022945381636 -2.0986 0.706506707405976 0.7065054386647804 -2.146651001504185e-07 -0.09966033249448425 -2.0987000000000005 0.7065068878171153 0.7065056227567356 -2.1455122428334916e-07 -0.09966043550395656 -2.0988 0.7065070681747423 0.7065058067917558 -2.1439787703525504e-07 -0.09966053848224277 -2.0989 0.7065072484792965 0.706505990769435 -2.142051056287786e-07 -0.09966064142935227 -2.099 0.7065074287312172 0.706506174689367 -2.1397296631059382e-07 -0.0996607443452945 -2.0991 0.706507608930943 0.7065063585511471 -2.137015244242646e-07 -0.09966084723007884 -2.0992 0.7065077890789112 0.7065065423543707 -2.133908543408558e-07 -0.09966095008371467 -2.0993000000000004 0.7065079691755587 0.7065067260986344 -2.1304103942076935e-07 -0.09966105290621136 -2.0994 0.7065081492213212 0.7065069097835359 -2.1265217203109144e-07 -0.09966115569757839 -2.0995 0.7065083292166335 0.7065070934086741 -2.1222435350048974e-07 -0.09966125845782511 -2.0995999999999997 0.7065085091619288 0.7065072769736489 -2.1175769412268286e-07 -0.09966136118696091 -2.0997000000000003 0.7065086890576389 0.706507460478061 -2.112523130870514e-07 -0.09966146388499514 -2.0998 0.7065088689041952 0.7065076439215134 -2.1070833847516846e-07 -0.09966156655193727 -2.0999 0.7065090487020265 0.7065078273036103 -2.1012590721916635e-07 -0.09966166918779665 -2.1 0.7065092284515603 0.706508010623957 -2.0950516507398098e-07 -0.09966177179258258 -2.1001 0.7065094081532227 0.7065081938821611 -2.088462665479629e-07 -0.09966187436630455 -2.1002 0.706509587807438 0.7065083770778314 -2.081493749375718e-07 -0.09966197690897184 -2.1003000000000003 0.7065097674146283 0.706508560210579 -2.0741466222329308e-07 -0.09966207942059387 -2.1004 0.7065099469752143 0.7065087432800166 -2.0664230903147396e-07 -0.09966218190118002 -2.1005 0.7065101264896139 0.7065089262857593 -2.05832504630854e-07 -0.0996622843507396 -2.1006 0.7065103059582434 0.706509109227424 -2.0498544684929842e-07 -0.099662386769282 -2.1007000000000002 0.706510485381517 0.7065092921046301 -2.0410134202522578e-07 -0.0996624891568166 -2.1008 0.7065106647598458 0.7065094749169991 -2.031804049971997e-07 -0.09966259151335272 -2.1009 0.7065108440936395 0.7065096576641549 -2.0222285900678427e-07 -0.09966269383889971 -2.101 0.7065110233833043 0.7065098403457243 -2.0122893566731914e-07 -0.09966279613346697 -2.1010999999999997 0.7065112026292447 0.7065100229613361 -2.0019887490146937e-07 -0.09966289839706383 -2.1012000000000004 0.7065113818318619 0.7065102055106223 -1.9913292487183654e-07 -0.0996630006296996 -2.1013 0.7065115609915547 0.7065103879932171 -1.9803134195320315e-07 -0.09966310283138367 -2.1014 0.7065117401087189 0.706510570408758 -1.9689439065620484e-07 -0.09966320500212537 -2.1015 0.7065119191837469 0.706510752756885 -1.957223435371247e-07 -0.09966330714193396 -2.1016 0.706512098217029 0.7065109350372418 -1.945154811909544e-07 -0.09966340925081887 -2.1017 0.7065122772089517 0.7065111172494748 -1.932740920917997e-07 -0.09966351132878941 -2.1018000000000003 0.7065124561598985 0.7065112993932332 -1.9199847263451364e-07 -0.09966361337585486 -2.1019 0.7065126350702496 0.7065114814681703 -1.9068892699244944e-07 -0.09966371539202461 -2.102 0.7065128139403818 0.7065116634739421 -1.893457670654186e-07 -0.0996638173773079 -2.1021 0.7065129927706688 0.7065118454102084 -1.8796931239989378e-07 -0.09966391933171415 -2.1022000000000003 0.7065131715614801 0.7065120272766321 -1.865598901196197e-07 -0.09966402125525259 -2.1023 0.7065133503131822 0.7065122090728803 -1.8511783483540767e-07 -0.09966412314793263 -2.1024000000000003 0.7065135290261377 0.706512390798623 -1.8364348858615487e-07 -0.09966422500976348 -2.1025 0.7065137077007051 0.7065125724535352 -1.8213720074516937e-07 -0.09966432684075449 -2.1026 0.7065138863372395 0.7065127540372941 -1.8059932794384226e-07 -0.09966442864091496 -2.1027000000000005 0.7065140649360921 0.7065129355495822 -1.7903023397450313e-07 -0.09966453041025422 -2.1028000000000002 0.7065142434976098 0.7065131169900852 -1.7743028971409225e-07 -0.09966463214878155 -2.1029 0.7065144220221358 0.7065132983584932 -1.7579987303395495e-07 -0.09966473385650625 -2.103 0.7065146005100085 0.7065134796545005 -1.7413936872004432e-07 -0.09966483553343759 -2.1031 0.7065147789615628 0.7065136608778051 -1.724491683653684e-07 -0.0996649371795849 -2.1032 0.706514957377129 0.7065138420281099 -1.7072967029366226e-07 -0.09966503879495743 -2.1033000000000004 0.7065151357570328 0.7065140231051218 -1.6898127945703945e-07 -0.09966514037956448 -2.1034 0.7065153141015961 0.7065142041085521 -1.6720440733884734e-07 -0.09966524193341533 -2.1035 0.7065154924111355 0.7065143850381173 -1.653994718634616e-07 -0.09966534345651931 -2.1035999999999997 0.7065156706859639 0.706514565893537 -1.6356689729393747e-07 -0.09966544494888564 -2.1037000000000003 0.7065158489263887 0.706514746674537 -1.6170711412619165e-07 -0.09966554641052364 -2.1038 0.7065160271327133 0.7065149273808468 -1.5982055899879666e-07 -0.09966564784144255 -2.1039 0.7065162053052358 0.7065151080122007 -1.579076746010405e-07 -0.09966574924165159 -2.104 0.70651638344425 0.7065152885683386 -1.5596890954108766e-07 -0.09966585061116015 -2.1041 0.7065165615500446 0.7065154690490042 -1.5400471825403883e-07 -0.09966595194997743 -2.1042 0.7065167396229026 0.7065156494539471 -1.520155609047863e-07 -0.09966605325811266 -2.1043000000000003 0.7065169176631032 0.7065158297829213 -1.5000190325790974e-07 -0.09966615453557513 -2.1044 0.7065170956709197 0.706516010035686 -1.4796421659614423e-07 -0.09966625578237405 -2.1045 0.7065172736466209 0.7065161902120056 -1.4590297759027593e-07 -0.09966635699851875 -2.1046 0.7065174515904695 0.7065163703116498 -1.43818668193324e-07 -0.09966645818401841 -2.1047000000000002 0.7065176295027242 0.7065165503343934 -1.4171177553125303e-07 -0.09966655933888235 -2.1048 0.7065178073836373 0.7065167302800164 -1.3958279178327704e-07 -0.09966666046311978 -2.1049 0.7065179852334564 0.7065169101483042 -1.3743221406736783e-07 -0.09966676155673997 -2.105 0.7065181630524231 0.7065170899390474 -1.3526054433617152e-07 -0.09966686261975204 -2.1050999999999997 0.7065183408407743 0.7065172696520424 -1.3306828924343483e-07 -0.09966696365216536 -2.1052000000000004 0.706518518598741 0.706517449287091 -1.3085596004165645e-07 -0.09966706465398911 -2.1053 0.7065186963265486 0.7065176288440005 -1.2862407243983964e-07 -0.09966716562523256 -2.1054 0.7065188740244168 0.7065178083225836 -1.2637314651328668e-07 -0.09966726656590487 -2.1055 0.7065190516925599 0.7065179877226588 -1.2410370655267788e-07 -0.09966736747601529 -2.1056 0.7065192293311866 0.7065181670440506 -1.2181628096866182e-07 -0.09966746835557307 -2.1057 0.7065194069404996 0.7065183462865884 -1.1951140214613853e-07 -0.0996675692045874 -2.1058000000000003 0.706519584520696 0.7065185254501081 -1.1718960634017617e-07 -0.0996676700230675 -2.1059 0.7065197620719671 0.706518704534451 -1.1485143354070249e-07 -0.0996677708110226 -2.106 0.7065199395944983 0.7065188835394645 -1.1249742734240065e-07 -0.09966787156846191 -2.1061 0.7065201170884692 0.7065190624650015 -1.1012813483368689e-07 -0.09966797229539462 -2.1062000000000003 0.706520294554053 0.7065192413109211 -1.0774410644925903e-07 -0.09966807299182989 -2.1063 0.706520471991418 0.7065194200770889 -1.0534589585907417e-07 -0.09966817365777708 -2.1064000000000003 0.7065206494007255 0.7065195987633751 -1.02934059834775e-07 -0.09966827429324523 -2.1065 0.706520826782131 0.706519777369657 -1.0050915811524869e-07 -0.09966837489824364 -2.1066 0.7065210041357843 0.7065199558958175 -9.807175328779838e-08 -0.0996684754727814 -2.1067000000000005 0.7065211814618291 0.7065201343417458 -9.562241064763055e-08 -0.09966857601686785 -2.1068000000000002 0.7065213587604025 0.7065203127073372 -9.316169806861813e-08 -0.09966867653051203 -2.1069 0.7065215360316359 0.7065204909924929 -9.069018588100247e-08 -0.09966877701372323 -2.107 0.7065217132756545 0.7065206691971202 -8.82084467239419e-08 -0.0996688774665106 -2.1071 0.7065218904925771 0.7065208473211327 -8.571705542668312e-08 -0.09966897788888328 -2.1072 0.7065220676825164 0.7065210253644504 -8.321658885764027e-08 -0.09966907828085048 -2.1073000000000004 0.7065222448455791 0.7065212033269992 -8.070762581770946e-08 -0.09966917864242138 -2.1074 0.7065224219818657 0.7065213812087117 -7.819074688067418e-08 -0.09966927897360518 -2.1075 0.7065225990914699 0.7065215590095257 -7.566653427437675e-08 -0.09966937927441101 -2.1075999999999997 0.7065227761744793 0.7065217367293866 -7.31355717389047e-08 -0.09966947954484805 -2.1077000000000004 0.7065229532309758 0.7065219143682449 -7.059844439648646e-08 -0.09966957978492544 -2.1078 0.7065231302610344 0.7065220919260582 -6.80557386140146e-08 -0.09966967999465237 -2.1079 0.706523307264724 0.7065222694027905 -6.550804186470152e-08 -0.09966978017403805 -2.108 0.7065234842421071 0.7065224467984113 -6.295594259667428e-08 -0.09966988032309154 -2.1081 0.7065236611932397 0.7065226241128967 -6.040003009506398e-08 -0.09966998044182201 -2.1082 0.706523838118172 0.7065228013462297 -5.784089434864893e-08 -0.09967008053023864 -2.1083000000000003 0.7065240150169472 0.7065229784983988 -5.5279125906523147e-08 -0.09967018058835057 -2.1084 0.7065241918896028 0.7065231555694 -5.271531575102781e-08 -0.09967028061616699 -2.1085 0.7065243687361694 0.7065233325592344 -5.015005515680501e-08 -0.09967038061369697 -2.1086 0.7065245455566715 0.7065235094679099 -4.758393555527249e-08 -0.09967048058094968 -2.1087000000000002 0.7065247223511273 0.7065236862954407 -4.501754839497836e-08 -0.09967058051793422 -2.1088 0.7065248991195483 0.7065238630418478 -4.245148501179504e-08 -0.09967068042465976 -2.1089 0.70652507586194 0.706524039707158 -3.9886336487485055e-08 -0.09967078030113545 -2.109 0.7065252525783017 0.7065242162914049 -3.7322693518106013e-08 -0.09967088014737042 -2.1090999999999998 0.7065254292686259 0.7065243927946279 -3.476114627078749e-08 -0.09967097996337378 -2.1092000000000004 0.706525605932899 0.7065245692168731 -3.220228425625596e-08 -0.09967107974915464 -2.1093 0.7065257825711013 0.7065247455581924 -2.9646696188484825e-08 -0.09967117950472212 -2.1094 0.7065259591832062 0.7065249218186449 -2.7094969850226247e-08 -0.09967127923008536 -2.1095 0.7065261357691813 0.7065250979982952 -2.4547691957702705e-08 -0.09967137892525346 -2.1096 0.7065263123289879 0.7065252740972146 -2.2005448025840674e-08 -0.09967147859023552 -2.1097 0.7065264888625807 0.7065254501154803 -1.9468822235781114e-08 -0.09967157822504068 -2.1098000000000003 0.7065266653699085 0.706525626053176 -1.693839729371635e-08 -0.09967167782967802 -2.1099 0.7065268418509139 0.7065258019103919 -1.4414754306857347e-08 -0.09967177740415667 -2.11 0.7065270183055326 0.706525977687224 -1.1898472646824226e-08 -0.09967187694848575 -2.1101 0.7065271947336945 0.7065261533837746 -9.390129811302078e-09 -0.0996719764626743 -2.1102000000000003 0.7065273711353239 0.7065263290001518 -6.890301295671419e-09 -0.09967207594673146 -2.1103 0.7065275475103381 0.7065265045364704 -4.399560461602892e-09 -0.09967217540066625 -2.1104000000000003 0.7065277238586487 0.7065266799928516 -1.918478404784596e-09 -0.09967227482448786 -2.1105 0.7065279001801612 0.706526855369422 5.523761725800824e-10 -0.09967237421820536 -2.1106 0.7065280764747749 0.706527030666314 3.012437102718757e-09 -0.09967247358182778 -2.1107000000000005 0.7065282527423827 0.706527205883667 5.461140865047065e-09 -0.0996725729153642 -2.1108000000000002 0.7065284289828724 0.706527381021626 7.897926737956973e-09 -0.09967267221882377 -2.1109 0.706528605196125 0.7065275560803417 1.0322236898563375e-08 -0.09967277149221551 -2.111 0.7065287813820158 0.7065277310599712 1.2733516577961845e-08 -0.09967287073554855 -2.1111 0.7065289575404141 0.7065279059606773 1.5131214171383578e-08 -0.09967296994883192 -2.1112 0.7065291336711836 0.7065280807826285 1.7514781368299648e-08 -0.09967306913207467 -2.1113000000000004 0.7065293097741819 0.7065282555259993 1.988367328252527e-08 -0.09967316828528588 -2.1114 0.7065294858492608 0.70652843019097 2.2237348562374748e-08 -0.09967326740847464 -2.1115 0.7065296618962663 0.7065286047777269 2.4575269538112954e-08 -0.09967336650165 -2.1115999999999997 0.7065298379150389 0.7065287792864615 2.689690231996722e-08 -0.09967346556482097 -2.1117000000000004 0.7065300139054131 0.7065289537173713 2.920171694210938e-08 -0.09967356459799667 -2.1118 0.706530189867218 0.7065291280706596 3.1489187465871815e-08 -0.09967366360118611 -2.1119 0.7065303658002773 0.7065293023465347 3.375879209857602e-08 -0.09967376257439838 -2.112 0.7065305417044083 0.7065294765452114 3.6010013332310464e-08 -0.09967386151764251 -2.1121 0.7065307175794238 0.7065296506669089 3.824233804974875e-08 -0.09967396043092752 -2.1122 0.7065308934251306 0.7065298247118525 4.045525763343716e-08 -0.09967405931426249 -2.1123000000000003 0.70653106924133 0.7065299986802731 4.264826810283784e-08 -0.0996741581676564 -2.1124 0.7065312450278183 0.7065301725724062 4.482087019239134e-08 -0.09967425699111836 -2.1125 0.7065314207843865 0.7065303463884935 4.6972569512845896e-08 -0.09967435578465741 -2.1126 0.7065315965108199 0.7065305201287808 4.910287662932e-08 -0.0996744545482825 -2.1127000000000002 0.7065317722068987 0.7065306937935203 5.1211307177528864e-08 -0.0996745532820027 -2.1128 0.7065319478723986 0.7065308673829684 5.3297381990419224e-08 -0.09967465198582703 -2.1129000000000002 0.7065321235070896 0.7065310408973873 5.536062718317081e-08 -0.09967475065976454 -2.113 0.7065322991107367 0.7065312143370437 5.7400574281565864e-08 -0.09967484930382424 -2.1130999999999998 0.7065324746831003 0.706531387702209 5.9416760317398953e-08 -0.09967494791801511 -2.1132000000000004 0.7065326502239354 0.7065315609931604 6.140872792909091e-08 -0.09967504650234615 -2.1133 0.7065328257329926 0.7065317342101793 6.337602548658894e-08 -0.09967514505682644 -2.1134 0.7065330012100176 0.7065319073535521 6.531820716422498e-08 -0.09967524358146496 -2.1135 0.7065331766547513 0.70653208042357 6.723483306908529e-08 -0.09967534207627074 -2.1136 0.7065333520669298 0.7065322534205282 6.91254693173382e-08 -0.09967544054125275 -2.1137 0.7065335274462848 0.706532426344727 7.098968815219542e-08 -0.09967553897641997 -2.1138000000000003 0.7065337027925436 0.7065325991964715 7.282706802891337e-08 -0.09967563738178144 -2.1139 0.7065338781054289 0.706532771976071 7.463719371193778e-08 -0.09967573575734619 -2.114 0.7065340533846591 0.7065329446838386 7.641965636337456e-08 -0.09967583410312317 -2.1141 0.7065342286299481 0.7065331173200924 7.817405365574681e-08 -0.09967593241912134 -2.1142000000000003 0.7065344038410055 0.7065332898851544 7.989998983964908e-08 -0.09967603070534971 -2.1143 0.7065345790175369 0.7065334623793508 8.15970758391571e-08 -0.09967612896181723 -2.1144000000000003 0.7065347541592444 0.7065336348030121 8.326492934897234e-08 -0.09967622718853296 -2.1145 0.7065349292658248 0.7065338071564728 8.490317490207622e-08 -0.09967632538550583 -2.1146 0.7065351043369721 0.7065339794400709 8.651144398422184e-08 -0.09967642355274486 -2.1147000000000005 0.7065352793723758 0.706534151654149 8.808937508250625e-08 -0.09967652169025899 -2.1148000000000002 0.7065354543717215 0.7065343237990525 8.963661378771914e-08 -0.09967661979805714 -2.1149 0.7065356293346917 0.7065344958751315 9.115281287414012e-08 -0.09967671787614837 -2.115 0.706535804260965 0.7065346678827392 9.263763234637623e-08 -0.09967681592454164 -2.1151 0.7065359791502158 0.7065348398222324 9.40907395746704e-08 -0.09967691394324585 -2.1152 0.706536154002116 0.7065350116939715 9.551180932612646e-08 -0.09967701193227 -2.1153000000000004 0.7065363288163335 0.70653518349832 9.690052384103698e-08 -0.09967710989162301 -2.1154 0.7065365035925331 0.7065353552356453 9.825657289880274e-08 -0.0996772078213139 -2.1155 0.7065366783303764 0.7065355269063175 9.957965392548562e-08 -0.09967730572135161 -2.1155999999999997 0.7065368530295212 0.7065356985107101 1.0086947199380858e-07 -0.09967740359174505 -2.1157000000000004 0.7065370276896232 0.7065358700491995 1.0212573996540297e-07 -0.09967750143250319 -2.1158 0.7065372023103346 0.7065360415221651 1.0334817850815581e-07 -0.09967759924363498 -2.1159 0.7065373768913048 0.7065362129299895 1.0453651615172088e-07 -0.09967769702514935 -2.116 0.7065375514321801 0.7065363842730574 1.0569048938119385e-07 -0.09967779477705521 -2.1161 0.7065377259326043 0.7065365555517571 1.0680984267527616e-07 -0.09967789249936153 -2.1162 0.7065379003922189 0.706536726766479 1.078943285721945e-07 -0.09967799019207724 -2.1163000000000003 0.7065380748106623 0.7065368979176164 1.0894370771133421e-07 -0.09967808785521132 -2.1164 0.7065382491875707 0.7065370690055648 1.0995774887834209e-07 -0.09967818548877265 -2.1165 0.7065384235225776 0.7065372400307219 1.1093622907451528e-07 -0.09967828309277013 -2.1166 0.7065385978153146 0.7065374109934881 1.1187893356884304e-07 -0.09967838066721273 -2.1167000000000002 0.7065387720654107 0.7065375818942654 1.1278565595698731e-07 -0.09967847821210929 -2.1168 0.7065389462724936 0.706537752733459 1.1365619815087435e-07 -0.09967857572746885 -2.1169000000000002 0.7065391204361877 0.706537923511475 1.1449037046890043e-07 -0.09967867321330025 -2.117 0.7065392945561166 0.7065380942287222 1.1528799169144288e-07 -0.09967877066961245 -2.1170999999999998 0.7065394686319014 0.7065382648856104 1.1604888903310462e-07 -0.0996788680964143 -2.1172000000000004 0.7065396426631616 0.7065384354825519 1.1677289825026693e-07 -0.09967896549371469 -2.1173 0.7065398166495154 0.7065386060199603 1.1745986364108951e-07 -0.09967906286152259 -2.1174 0.7065399905905787 0.7065387764982514 1.1810963807673547e-07 -0.09967916019984692 -2.1175 0.7065401644859668 0.7065389469178411 1.1872208305341303e-07 -0.09967925750869651 -2.1176 0.7065403383352927 0.7065391172791481 1.19297068695845e-07 -0.09967935478808031 -2.1177 0.7065405121381689 0.7065392875825915 1.1983447380931045e-07 -0.09967945203800715 -2.1178000000000003 0.706540685894206 0.706539457828592 1.2033418588658362e-07 -0.09967954925848599 -2.1179 0.7065408596030143 0.7065396280175713 1.207961011495673e-07 -0.09967964644952569 -2.118 0.7065410332642024 0.7065397981499519 1.2122012454582332e-07 -0.09967974361113513 -2.1181 0.7065412068773779 0.7065399682261574 1.2160616978673655e-07 -0.09967984074332313 -2.1182000000000003 0.7065413804421485 0.7065401382466122 1.219541593579232e-07 -0.09967993784609869 -2.1183 0.7065415539581205 0.7065403082117415 1.2226402455392527e-07 -0.09968003491947061 -2.1184000000000003 0.7065417274248993 0.7065404781219713 1.2253570544004666e-07 -0.09968013196344784 -2.1185 0.7065419008420903 0.7065406479777272 1.2276915092868101e-07 -0.09968022897803917 -2.1186 0.7065420742092984 0.7065408177794363 1.2296431873420888e-07 -0.09968032596325348 -2.1187000000000005 0.7065422475261278 0.7065409875275257 1.2312117542156997e-07 -0.09968042291909968 -2.1188000000000002 0.7065424207921827 0.7065411572224225 1.2323969637850762e-07 -0.09968051984558661 -2.1189 0.7065425940070671 0.7065413268645544 1.233198658259771e-07 -0.09968061674272315 -2.119 0.7065427671703852 0.7065414964543486 1.2336167685284005e-07 -0.09968071361051814 -2.1191 0.7065429402817405 0.7065416659922328 1.2336513136035343e-07 -0.09968081044898044 -2.1192 0.7065431133407375 0.7065418354786339 1.2333024009686389e-07 -0.0996809072581189 -2.1193 0.7065432863469803 0.7065420049139792 1.2325702264046057e-07 -0.09968100403794236 -2.1194 0.7065434593000735 0.7065421742986957 1.2314550739897512e-07 -0.09968110078845971 -2.1195 0.7065436321996221 0.7065423436332097 1.2299573161692057e-07 -0.09968119750967977 -2.1195999999999997 0.706543805045232 0.7065425129179466 1.2280774127834682e-07 -0.09968129420161137 -2.1197000000000004 0.7065439778365088 0.706542682153332 1.2258159122133239e-07 -0.09968139086426336 -2.1198 0.7065441505730599 0.7065428513397902 1.2231734503043157e-07 -0.0996814874976446 -2.1199 0.7065443232544926 0.7065430204777452 1.220150750574911e-07 -0.0996815841017639 -2.12 0.7065444958804152 0.7065431895676194 1.2167486238348624e-07 -0.09968168067663007 -2.1201 0.7065446684504375 0.706543358609835 1.2129679680811245e-07 -0.09968177722225197 -2.1202 0.70654484096417 0.7065435276048129 1.2088097683243815e-07 -0.09968187373863849 -2.1203000000000003 0.7065450134212243 0.7065436965529723 1.2042750962767967e-07 -0.09968197022579833 -2.1204 0.7065451858212133 0.7065438654547318 1.199365110039763e-07 -0.0996820666837404 -2.1205 0.7065453581637513 0.7065440343105083 1.194081053618179e-07 -0.09968216311247348 -2.1206 0.7065455304484543 0.7065442031207174 1.1884242573714787e-07 -0.09968225951200642 -2.1207000000000003 0.7065457026749391 0.7065443718857731 1.1823961366605462e-07 -0.09968235588234799 -2.1208 0.7065458748428248 0.7065445406060877 1.1759981919171048e-07 -0.09968245222350701 -2.1209000000000002 0.7065460469517322 0.7065447092820719 1.1692320087824948e-07 -0.09968254853549231 -2.121 0.7065462190012834 0.7065448779141343 1.1620992568933675e-07 -0.09968264481831267 -2.1210999999999998 0.7065463909911028 0.7065450465026826 1.1546016899510736e-07 -0.09968274107197694 -2.1212000000000004 0.7065465629208166 0.7065452150481211 1.1467411451318577e-07 -0.09968283729649391 -2.1213 0.7065467347900534 0.7065453835508526 1.138519542878691e-07 -0.09968293349187235 -2.1214 0.7065469065984433 0.7065455520112782 1.1299388859992154e-07 -0.09968302965812109 -2.1215 0.7065470783456194 0.7065457204297961 1.1210012594575769e-07 -0.09968312579524888 -2.1216 0.7065472500312164 0.7065458888068025 1.1117088300968692e-07 -0.0996832219032645 -2.1217 0.7065474216548719 0.706546057142691 1.1020638454942167e-07 -0.0996833179821768 -2.1218000000000004 0.7065475932162261 0.7065462254378528 1.0920686339954688e-07 -0.09968341403199449 -2.1219 0.7065477647149214 0.7065463936926766 1.0817256039519219e-07 -0.09968351005272642 -2.122 0.7065479361506032 0.7065465619075479 1.0710372430264292e-07 -0.09968360604438135 -2.1221 0.7065481075229196 0.7065467300828504 1.0600061177423736e-07 -0.0996837020069681 -2.1222000000000003 0.7065482788315213 0.7065468982189635 1.0486348728244721e-07 -0.09968379794049533 -2.1223 0.7065484500760623 0.7065470663162652 1.0369262305048865e-07 -0.09968389384497192 -2.1224000000000003 0.7065486212561993 0.7065472343751296 1.0248829901415846e-07 -0.0996839897204066 -2.1225 0.7065487923715923 0.7065474023959277 1.0125080270387277e-07 -0.09968408556680813 -2.1226 0.7065489634219042 0.7065475703790276 9.998042922731987e-08 -0.09968418138418529 -2.1227000000000005 0.7065491344068014 0.706547738324794 9.867748117578512e-08 -0.09968427717254678 -2.1228000000000002 0.706549305325954 0.7065479062335883 9.734226853741479e-08 -0.09968437293190147 -2.1229 0.7065494761790346 0.7065480741057686 9.597510867639936e-08 -0.09968446866225805 -2.123 0.70654964696572 0.7065482419416889 9.457632619419565e-08 -0.09968456436362523 -2.1231 0.7065498176856905 0.7065484097417005 9.314625289136291e-08 -0.09968466003601185 -2.1232 0.7065499883386297 0.7065485775061504 9.168522766347942e-08 -0.09968475567942661 -2.1233 0.7065501589242251 0.7065487452353824 9.019359644216185e-08 -0.09968485129387827 -2.1234 0.7065503294421682 0.7065489129297358 8.867171213261527e-08 -0.09968494687937557 -2.1235 0.7065504998921541 0.7065490805895465 8.711993446444688e-08 -0.09968504243592723 -2.1235999999999997 0.706550670273882 0.7065492482151464 8.553862996737993e-08 -0.099685137963542 -2.1237000000000004 0.7065508405870549 0.7065494158068633 8.39281718619661e-08 -0.0996852334622286 -2.1238 0.7065510108313802 0.7065495833650213 8.228893997111464e-08 -0.09968532893199582 -2.1239 0.706551181006569 0.7065497508899395 8.062132064376448e-08 -0.09968542437285235 -2.124 0.7065513511123371 0.7065499183819333 7.892570663518839e-08 -0.09968551978480687 -2.1241 0.7065515211484046 0.7065500858413141 7.720249704974702e-08 -0.0996856151678682 -2.1242 0.7065516911144955 0.7065502532683883 7.545209720558055e-08 -0.09968571052204502 -2.1243000000000003 0.7065518610103385 0.7065504206634582 7.367491859991415e-08 -0.09968580584734603 -2.1244 0.7065520308356665 0.7065505880268215 7.18713787442593e-08 -0.09968590114377991 -2.1245 0.7065522005902178 0.7065507553587713 7.004190110890263e-08 -0.09968599641135546 -2.1246 0.7065523702737346 0.7065509226595967 6.818691501882246e-08 -0.09968609165008141 -2.1247000000000003 0.7065525398859634 0.7065510899295809 6.630685553919713e-08 -0.09968618685996636 -2.1248 0.7065527094266564 0.7065512571690036 6.440216338866878e-08 -0.09968628204101908 -2.1249000000000002 0.7065528788955698 0.7065514243781388 6.247328482138215e-08 -0.09968637719324827 -2.125 0.7065530482924656 0.7065515915572558 6.052067152637064e-08 -0.0996864723166626 -2.1250999999999998 0.7065532176171094 0.7065517587066199 5.8544780544289576e-08 -0.09968656741127085 -2.1252000000000004 0.7065533868692728 0.70655192582649 5.6546074128638324e-08 -0.09968666247708163 -2.1253 0.7065535560487319 0.706552092917121 5.452501964514633e-08 -0.09968675751410366 -2.1254 0.7065537251552684 0.7065522599787621 5.248208947115918e-08 -0.09968685252234567 -2.1255 0.7065538941886684 0.7065524270116579 5.0417760888085694e-08 -0.09968694750181634 -2.1256 0.7065540631487237 0.7065525940160473 4.833251596517152e-08 -0.09968704245252424 -2.1257 0.7065542320352312 0.7065527609921644 4.62268414502115e-08 -0.09968713737447817 -2.1258000000000004 0.7065544008479929 0.7065529279402376 4.4101228630771816e-08 -0.09968723226768678 -2.1259 0.7065545695868167 0.7065530948604903 4.1956173254392715e-08 -0.09968732713215876 -2.126 0.7065547382515152 0.7065532617531405 3.979217540195368e-08 -0.09968742196790276 -2.1261 0.7065549068419066 0.7065534286184006 3.760973936277334e-08 -0.09968751677492747 -2.1262000000000003 0.7065550753578147 0.7065535954564778 3.5409373528791366e-08 -0.09968761155324155 -2.1263 0.7065552437990686 0.7065537622675733 3.319159026099472e-08 -0.09968770630285367 -2.1264000000000003 0.7065554121655035 0.7065539290518832 3.0956905788803724e-08 -0.09968780102377252 -2.1265 0.7065555804569595 0.7065540958095978 2.8705840079967793e-08 -0.09968789571600675 -2.1266 0.7065557486732825 0.7065542625409018 2.643891671046117e-08 -0.09968799037956497 -2.1267000000000005 0.7065559168143243 0.7065544292459744 2.415666276213424e-08 -0.0996880850144559 -2.1268000000000002 0.7065560848799424 0.706554595924989 2.1859608680466214e-08 -0.09968817962068821 -2.1269 0.7065562528699995 0.7065547625781131 1.954828817048171e-08 -0.09968827419827049 -2.127 0.7065564207843644 0.7065549292055084 1.7223238067513857e-08 -0.09968836874721139 -2.1271 0.7065565886229122 0.706555095807331 1.4884998194956978e-08 -0.09968846326751957 -2.1272 0.706556756385523 0.7065552623837315 1.2534111264519976e-08 -0.09968855775920372 -2.1273 0.706556924072083 0.7065554289348537 1.0171122736581106e-08 -0.09968865222227241 -2.1274 0.7065570916824848 0.7065555954608362 7.796580692685795e-09 -0.09968874665673436 -2.1275 0.7065572592166262 0.7065557619618115 5.411035711513912e-09 -0.09968884106259811 -2.1275999999999997 0.7065574266744112 0.7065559284379064 3.0150407457144035e-09 -0.09968893543987235 -2.1277000000000004 0.7065575940557498 0.7065560948892414 6.091509822600538e-10 -0.0996890297885657 -2.1278 0.7065577613605583 0.706556261315931 -1.8060762720442658e-09 -0.09968912410868679 -2.1279 0.7065579285887584 0.7065564277180839 -4.230081730206836e-09 -0.09968921840024422 -2.128 0.7065580957402784 0.7065565940958027 -6.662304250816542e-09 -0.09968931266324668 -2.1281 0.7065582628150517 0.7065567604491838 -9.102180964677686e-09 -0.09968940689770273 -2.1282 0.7065584298130192 0.706556926778318 -1.1549147408383698e-08 -0.09968950110362101 -2.1283000000000003 0.7065585967341264 0.7065570930832894 -1.4002637660492923e-08 -0.09968959528101012 -2.1284 0.706558763578326 0.7065572593641763 -1.6462084462091908e-08 -0.09968968942987871 -2.1285 0.7065589303455763 0.7065574256210511 -1.8926919354705918e-08 -0.09968978355023539 -2.1286 0.7065590970358417 0.7065575918539793 -2.1396572806500064e-08 -0.0996898776420887 -2.1287000000000003 0.7065592636490926 0.7065577580630213 -2.38704743484551e-08 -0.09968997170544727 -2.1288 0.706559430185306 0.706557924248231 -2.6348052704038005e-08 -0.09969006574031977 -2.1289000000000002 0.7065595966444647 0.7065580904096558 -2.882873592104096e-08 -0.09969015974671475 -2.129 0.7065597630265578 0.7065582565473372 -3.1311951502552976e-08 -0.0996902537246408 -2.1290999999999998 0.7065599293315801 0.7065584226613104 -3.3797126542485165e-08 -0.0996903476741065 -2.1292000000000004 0.7065600955595333 0.7065585887516048 -3.6283687854699216e-08 -0.0996904415951205 -2.1293 0.7065602617104246 0.7065587548182437 -3.877106210712321e-08 -0.09969053548769138 -2.1294 0.7065604277842674 0.7065589208612433 -4.125867595006693e-08 -0.09969062935182765 -2.1295 0.706560593781082 0.7065590868806146 -4.3745956152994e-08 -0.09969072318753798 -2.1296 0.706560759700894 0.7065592528763622 -4.623232973443637e-08 -0.0996908169948309 -2.1297 0.7065609255437353 0.7065594188484845 -4.8717224094023057e-08 -0.09969091077371502 -2.1298000000000004 0.7065610913096441 0.7065595847969737 -5.120006714399387e-08 -0.09969100452419888 -2.1299 0.7065612569986649 0.7065597507218158 -5.368028744125522e-08 -0.09969109824629109 -2.13 0.7065614226108479 0.7065599166229908 -5.615731431913781e-08 -0.09969119194000019 -2.1301 0.7065615881462496 0.7065600825004725 -5.8630578019316926e-08 -0.09969128560533475 -2.1302000000000003 0.7065617536049329 0.706560248354229 -6.109950981877249e-08 -0.09969137924230337 -2.1303 0.7065619189869665 0.7065604141842219 -6.356354216672383e-08 -0.09969147285091462 -2.1304000000000003 0.706562084292425 0.7065605799904064 -6.602210881169815e-08 -0.09969156643117702 -2.1305 0.7065622495213892 0.7065607457727323 -6.847464492686431e-08 -0.09969165998309915 -2.1306 0.7065624146739462 0.7065609115311431 -7.092058725228015e-08 -0.09969175350668959 -2.1307000000000005 0.7065625797501889 0.7065610772655762 -7.335937421372105e-08 -0.09969184700195688 -2.1308000000000002 0.7065627447502159 0.7065612429759629 -7.579044605365154e-08 -0.09969194046890953 -2.1309 0.7065629096741322 0.7065614086622287 -7.82132449587275e-08 -0.0996920339075561 -2.131 0.7065630745220488 0.706561574324293 -8.06272151899004e-08 -0.0996921273179052 -2.1311 0.7065632392940825 0.7065617399620695 -8.303180321165421e-08 -0.09969222069996532 -2.1312 0.7065634039903557 0.7065619055754657 -8.542645781820651e-08 -0.09969231405374498 -2.1313 0.7065635686109972 0.7065620711643833 -8.781063025493918e-08 -0.09969240737925278 -2.1314 0.7065637331561415 0.7065622367287181 -9.018377434676789e-08 -0.09969250067649721 -2.1315 0.7065638976259285 0.7065624022683599 -9.254534662737901e-08 -0.09969259394548674 -2.1315999999999997 0.7065640620205045 0.7065625677831933 -9.489480645979292e-08 -0.09969268718622999 -2.1317000000000004 0.7065642263400211 0.7065627332730966 -9.723161615432518e-08 -0.09969278039873551 -2.1318 0.7065643905846364 0.7065628987379426 -9.95552411030276e-08 -0.09969287358301182 -2.1319 0.706564554754513 0.7065630641775984 -1.0186514989678208e-07 -0.09969296673906738 -2.132 0.70656471884982 0.7065632295919251 -1.0416081444759862e-07 -0.09969305986691077 -2.1321 0.7065648828707319 0.7065633949807782 -1.0644171010137232e-07 -0.09969315296655046 -2.1322 0.7065650468174289 0.7065635603440084 -1.0870731577232451e-07 -0.099693246037995 -2.1323000000000003 0.7065652106900966 0.7065637256814596 -1.1095711405229025e-07 -0.09969333908125287 -2.1324 0.706565374488926 0.7065638909929712 -1.1319059132867959e-07 -0.0996934320963326 -2.1325 0.7065655382141138 0.7065640562783768 -1.1540723790330609e-07 -0.0996935250832427 -2.1326 0.706565701865862 0.7065642215375045 -1.1760654811468485e-07 -0.09969361804199167 -2.1327000000000003 0.7065658654443779 0.706564386770177 -1.1978802044558534e-07 -0.09969371097258799 -2.1328 0.7065660289498743 0.7065645519762116 -1.2195115763752318e-07 -0.09969380387504018 -2.1329000000000002 0.7065661923825691 0.7065647171554206 -1.2409546679831296e-07 -0.09969389674935672 -2.133 0.7065663557426858 0.7065648823076112 -1.2622045953911143e-07 -0.09969398959554616 -2.1330999999999998 0.7065665190304526 0.7065650474325844 -1.283256520576842e-07 -0.09969408241361695 -2.1332000000000004 0.7065666822461032 0.7065652125301374 -1.3041056527024475e-07 -0.0996941752035776 -2.1333 0.7065668453898759 0.7065653776000612 -1.3247472488951695e-07 -0.09969426796543654 -2.1334 0.7065670084620146 0.7065655426421428 -1.345176615739213e-07 -0.09969436069920232 -2.1335 0.7065671714627679 0.7065657076561631 -1.365389109952292e-07 -0.09969445340488339 -2.1336 0.7065673343923893 0.706565872641899 -1.3853801397734067e-07 -0.09969454608248823 -2.1337 0.7065674972511369 0.7065660375991221 -1.4051451657261238e-07 -0.09969463873202532 -2.1338000000000004 0.7065676600392745 0.706566202527599 -1.4246797018502289e-07 -0.09969473135350315 -2.1339 0.7065678227570698 0.7065663674270922 -1.44397931662113e-07 -0.09969482394693023 -2.134 0.7065679854047953 0.7065665322973589 -1.4630396340080398e-07 -0.09969491651231494 -2.1341 0.7065681479827279 0.7065666971381519 -1.481856334341336e-07 -0.09969500904966576 -2.1342000000000003 0.7065683104911502 0.7065668619492196 -1.5004251554054382e-07 -0.09969510155899122 -2.1343 0.7065684729303479 0.7065670267303052 -1.5187418934969887e-07 -0.09969519404029974 -2.1344000000000003 0.706568635300612 0.7065671914811485 -1.5368024041881312e-07 -0.09969528649359977 -2.1345 0.7065687976022375 0.7065673562014843 -1.5546026032979554e-07 -0.09969537891889979 -2.1346 0.7065689598355239 0.7065675208910432 -1.5721384678292483e-07 -0.09969547131620829 -2.1347000000000005 0.7065691220007748 0.7065676855495511 -1.589406037026675e-07 -0.09969556368553362 -2.1348000000000003 0.706569284098298 0.7065678501767303 -1.606401412966585e-07 -0.09969565602688427 -2.1349 0.7065694461284053 0.706568014772299 -1.623120761753971e-07 -0.09969574834026869 -2.135 0.7065696080914129 0.706568179335971 -1.639560314251054e-07 -0.09969584062569534 -2.1351 0.7065697699876407 0.7065683438674565 -1.6557163668232122e-07 -0.09969593288317265 -2.1352 0.7065699318174126 0.7065685083664615 -1.6715852824145117e-07 -0.09969602511270909 -2.1353 0.7065700935810557 0.7065686728326885 -1.687163491050775e-07 -0.09969611731431308 -2.1354 0.7065702552789019 0.7065688372658359 -1.7024474908977627e-07 -0.09969620948799303 -2.1355 0.7065704169112862 0.7065690016655986 -1.7174338489550633e-07 -0.09969630163375741 -2.1355999999999997 0.7065705784785469 0.7065691660316675 -1.732119201975496e-07 -0.09969639375161458 -2.1357000000000004 0.7065707399810264 0.7065693303637307 -1.7465002568467503e-07 -0.099696485841573 -2.1358 0.7065709014190701 0.7065694946614725 -1.7605737916842612e-07 -0.0996965779036411 -2.1359 0.7065710627930271 0.7065696589245738 -1.7743366563516272e-07 -0.0996966699378273 -2.136 0.7065712241032494 0.706569823152712 -1.7877857734147073e-07 -0.09969676194414002 -2.1361 0.706571385350093 0.7065699873455616 -1.8009181384365247e-07 -0.09969685392258767 -2.1362 0.7065715465339163 0.706570151502794 -1.8137308210527947e-07 -0.09969694587317873 -2.1363000000000003 0.7065717076550808 0.7065703156240773 -1.8262209652841754e-07 -0.09969703779592155 -2.1364 0.7065718687139508 0.7065704797090767 -1.8383857904036294e-07 -0.09969712969082452 -2.1365 0.7065720297108944 0.7065706437574544 -1.850222591422146e-07 -0.09969722155789607 -2.1366 0.7065721906462814 0.7065708077688702 -1.8617287399561033e-07 -0.0996973133971446 -2.1367000000000003 0.706572351520485 0.7065709717429807 -1.8729016844007407e-07 -0.0996974052085785 -2.1368 0.7065725123338806 0.70657113567944 -1.883738950658742e-07 -0.09969749699220617 -2.1369000000000002 0.7065726730868469 0.7065712995778998 -1.894238142764737e-07 -0.09969758874803603 -2.137 0.706572833779764 0.7065714634380091 -1.9043969435098007e-07 -0.09969768047607645 -2.1370999999999998 0.7065729944130155 0.7065716272594146 -1.9142131146149266e-07 -0.09969777217633582 -2.1372000000000004 0.7065731549869865 0.7065717910417606 -1.923684497598388e-07 -0.09969786384882257 -2.1373 0.7065733155020646 0.7065719547846894 -1.9328090139492105e-07 -0.09969795549354503 -2.1374 0.7065734759586395 0.7065721184878411 -1.9415846657863667e-07 -0.09969804711051163 -2.1375 0.7065736363571029 0.7065722821508535 -1.9500095361363323e-07 -0.09969813869973072 -2.1376 0.7065737966978487 0.7065724457733626 -1.9580817895575864e-07 -0.0996982302612107 -2.1377 0.7065739569812723 0.7065726093550029 -1.9657996721406112e-07 -0.09969832179495997 -2.1378000000000004 0.706574117207771 0.7065727728954063 -1.9731615124793378e-07 -0.0996984133009868 -2.1379 0.7065742773777439 0.7065729363942036 -1.9801657214282842e-07 -0.09969850477929967 -2.138 0.7065744374915914 0.706573099851024 -1.986810792935223e-07 -0.0996985962299069 -2.1381 0.7065745975497161 0.7065732632654949 -1.9930953041105703e-07 -0.09969868765281685 -2.1382000000000003 0.7065747575525213 0.7065734266372423 -1.999017915470247e-07 -0.09969877904803792 -2.1383 0.7065749175004118 0.7065735899658909 -2.004577371352012e-07 -0.0996988704155784 -2.1384000000000003 0.7065750773937935 0.7065737532510646 -2.0097725002277134e-07 -0.0996989617554467 -2.1385 0.7065752372330744 0.7065739164923857 -2.014602214772676e-07 -0.09969905306765117 -2.1386 0.7065753970186623 0.7065740796894752 -2.0190655122473422e-07 -0.09969914435220022 -2.1387000000000005 0.7065755567509666 0.7065742428419535 -2.0231614746707427e-07 -0.09969923560910206 -2.1388000000000003 0.7065757164303973 0.7065744059494401 -2.0268892688204976e-07 -0.09969932683836517 -2.1389 0.7065758760573657 0.7065745690115537 -2.0302481468573164e-07 -0.09969941803999784 -2.139 0.706576035632283 0.7065747320279121 -2.03323744587397e-07 -0.09969950921400839 -2.1391 0.7065761951555619 0.7065748949981328 -2.0358565884157076e-07 -0.09969960036040519 -2.1392 0.7065763546276149 0.7065750579218324 -2.0381050825149516e-07 -0.09969969147919659 -2.1393 0.7065765140488555 0.7065752207986274 -2.0399825217259915e-07 -0.09969978257039094 -2.1394 0.7065766734196968 0.7065753836281339 -2.0414885852290676e-07 -0.09969987363399652 -2.1395 0.7065768327405525 0.7065755464099672 -2.0426230380038435e-07 -0.09969996467002164 -2.1395999999999997 0.706576992011837 0.7065757091437439 -2.04338573055185e-07 -0.09970005567847473 -2.1397000000000004 0.7065771512339638 0.7065758718290787 -2.0437765991393464e-07 -0.09970014665936405 -2.1398 0.706577310407347 0.706576034465588 -2.043795665797321e-07 -0.09970023761269797 -2.1399 0.7065774695324002 0.706576197052887 -2.0434430380092405e-07 -0.09970032853848475 -2.14 0.7065776286095371 0.7065763595905916 -2.042718908953911e-07 -0.09970041943673275 -2.1401 0.7065777876391708 0.7065765220783184 -2.0416235575748676e-07 -0.09970051030745022 -2.1402 0.706577946621714 0.7065766845156841 -2.0401573480599566e-07 -0.09970060115064558 -2.1403000000000003 0.706578105557579 0.7065768469023056 -2.0383207298760309e-07 -0.09970069196632703 -2.1404 0.7065782644471778 0.706577009237801 -2.036114237838338e-07 -0.09970078275450295 -2.1405 0.7065784232909212 0.7065771715217883 -2.033538491937048e-07 -0.09970087351518164 -2.1406 0.7065785820892194 0.706577333753887 -2.0305941968862262e-07 -0.09970096424837138 -2.1407000000000003 0.7065787408424822 0.706577495933717 -2.027282142054443e-07 -0.09970105495408046 -2.1408 0.7065788995511173 0.7065776580608993 -2.0236032014300798e-07 -0.09970114563231722 -2.1409000000000002 0.7065790582155327 0.7065778201350561 -2.0195583332396905e-07 -0.09970123628308993 -2.141 0.7065792168361344 0.7065779821558102 -2.0151485797745283e-07 -0.09970132690640687 -2.1411 0.7065793754133275 0.7065781441227863 -2.010375067008907e-07 -0.09970141750227633 -2.1412000000000004 0.7065795339475156 0.7065783060356101 -2.0052390045308122e-07 -0.09970150807070664 -2.1413 0.706579692439101 0.7065784678939087 -1.999741684778622e-07 -0.09970159861170604 -2.1414 0.7065798508884847 0.7065786296973104 -1.993884483526831e-07 -0.09970168912528286 -2.1415 0.7065800092960656 0.7065787914454458 -1.9876688587411317e-07 -0.09970177961144533 -2.1416 0.7065801676622416 0.7065789531379463 -1.9810963505784152e-07 -0.0997018700702018 -2.1417 0.7065803259874082 0.7065791147744455 -1.9741685810398257e-07 -0.09970196050156045 -2.1418000000000004 0.7065804842719594 0.7065792763545788 -1.9668872534503445e-07 -0.09970205090552961 -2.1419 0.7065806425162873 0.7065794378779837 -1.9592541520424556e-07 -0.09970214128211755 -2.142 0.7065808007207818 0.7065795993442994 -1.9512711416438955e-07 -0.09970223163133252 -2.1421 0.7065809588858307 0.7065797607531674 -1.9429401671572366e-07 -0.0997023219531828 -2.1422000000000003 0.7065811170118199 0.7065799221042315 -1.934263252970081e-07 -0.09970241224767665 -2.1423 0.7065812750991329 0.7065800833971372 -1.9252425027815878e-07 -0.09970250251482236 -2.1424000000000003 0.7065814331481505 0.706580244631533 -1.9158800985963342e-07 -0.09970259275462816 -2.1425 0.7065815911592512 0.7065804058070693 -1.9061783006896205e-07 -0.09970268296710226 -2.1426 0.7065817491328115 0.7065805669233995 -1.8961394468094972e-07 -0.09970277315225298 -2.1427000000000005 0.7065819070692047 0.7065807279801792 -1.8857659516563485e-07 -0.09970286331008854 -2.1428000000000003 0.7065820649688015 0.7065808889770673 -1.8750603063277804e-07 -0.09970295344061725 -2.1429 0.7065822228319698 0.7065810499137244 -1.8640250777982037e-07 -0.09970304354384725 -2.143 0.7065823806590752 0.706581210789815 -1.8526629079473889e-07 -0.09970313361978686 -2.1431 0.7065825384504796 0.7065813716050058 -1.8409765133522993e-07 -0.0997032236684443 -2.1432 0.7065826962065421 0.7065815323589668 -1.8289686845585074e-07 -0.09970331368982778 -2.1433 0.7065828539276192 0.7065816930513715 -1.8166422852822217e-07 -0.0997034036839456 -2.1434 0.7065830116140636 0.7065818536818961 -1.8040002517163978e-07 -0.09970349365080595 -2.1435 0.7065831692662249 0.7065820142502195 -1.7910455920797097e-07 -0.09970358359041705 -2.1435999999999997 0.7065833268844497 0.706582174756025 -1.7777813855063274e-07 -0.09970367350278717 -2.1437000000000004 0.706583484469081 0.7065823351989986 -1.7642107815948882e-07 -0.09970376338792449 -2.1438 0.7065836420204582 0.7065824955788299 -1.750336999714608e-07 -0.09970385324583725 -2.1439 0.7065837995389175 0.706582655895212 -1.7361633279644462e-07 -0.09970394307653366 -2.144 0.706583957024791 0.706582816147842 -1.7216931227047316e-07 -0.099704032880022 -2.1441 0.7065841144784075 0.7065829763364202 -1.706929807325508e-07 -0.09970412265631046 -2.1442 0.7065842719000919 0.7065831364606507 -1.6918768721251032e-07 -0.09970421240540718 -2.1443000000000003 0.7065844292901651 0.7065832965202417 -1.6765378728182678e-07 -0.09970430212732041 -2.1444 0.7065845866489446 0.7065834565149051 -1.6609164300331047e-07 -0.09970439182205845 -2.1445 0.7065847439767434 0.7065836164443569 -1.6450162284610548e-07 -0.0997044814896294 -2.1446 0.7065849012738707 0.7065837763083169 -1.6288410158160627e-07 -0.09970457113004154 -2.1447000000000003 0.7065850585406315 0.7065839361065092 -1.6123946021233404e-07 -0.099704660743303 -2.1448 0.7065852157773265 0.706584095838662 -1.5956808586264914e-07 -0.099704750329422 -2.1449000000000003 0.7065853729842528 0.7065842555045072 -1.5787037172670937e-07 -0.09970483988840673 -2.145 0.7065855301617026 0.7065844151037826 -1.5614671692275317e-07 -0.09970492942026543 -2.1451 0.7065856873099636 0.7065845746362281 -1.543975264358538e-07 -0.09970501892500624 -2.1452000000000004 0.7065858444293196 0.7065847341015898 -1.526232110051623e-07 -0.09970510840263738 -2.1453 0.7065860015200498 0.7065848934996176 -1.5082418705798795e-07 -0.09970519785316703 -2.1454 0.7065861585824285 0.706585052830066 -1.4900087657795935e-07 -0.09970528727660335 -2.1455 0.7065863156167256 0.706585212092694 -1.4715370700614516e-07 -0.09970537667295457 -2.1456 0.7065864726232067 0.7065853712872654 -1.4528311117339987e-07 -0.09970546604222885 -2.1457 0.7065866296021321 0.7065855304135484 -1.433895271667901e-07 -0.09970555538443435 -2.1458000000000004 0.7065867865537578 0.7065856894713165 -1.414733982324501e-07 -0.09970564469957927 -2.1459 0.7065869434783345 0.7065858484603476 -1.3953517268364135e-07 -0.09970573398767174 -2.146 0.7065871003761084 0.7065860073804244 -1.3757530379493454e-07 -0.09970582324871996 -2.1461 0.7065872572473209 0.7065861662313351 -1.3559424969292189e-07 -0.09970591248273214 -2.1462000000000003 0.7065874140922078 0.7065863250128719 -1.3359247323652124e-07 -0.09970600168971637 -2.1463 0.7065875709110006 0.706586483724833 -1.3157044193197465e-07 -0.09970609086968085 -2.1464000000000003 0.7065877277039248 0.7065866423670213 -1.2952862780794827e-07 -0.0997061800226337 -2.1465 0.7065878844712019 0.7065868009392446 -1.274675073079795e-07 -0.09970626914858315 -2.1466 0.7065880412130476 0.7065869594413161 -1.253875611863936e-07 -0.0997063582475373 -2.1467 0.7065881979296722 0.7065871178730543 -1.232892743799341e-07 -0.09970644731950427 -2.1468000000000003 0.7065883546212812 0.7065872762342825 -1.2117313591755718e-07 -0.0997065363644923 -2.1469 0.7065885112880743 0.70658743452483 -1.190396387885928e-07 -0.09970662538250948 -2.147 0.7065886679302466 0.7065875927445306 -1.1688927982998754e-07 -0.09970671437356399 -2.1471 0.7065888245479868 0.7065877508932245 -1.1472255962395594e-07 -0.09970680333766391 -2.1472 0.7065889811414791 0.7065879089707561 -1.1253998236267215e-07 -0.09970689227481742 -2.1473 0.7065891377109019 0.7065880669769762 -1.1034205575286005e-07 -0.09970698118503266 -2.1474 0.706589294256428 0.7065882249117408 -1.0812929087528067e-07 -0.0997070700683178 -2.1475 0.7065894507782248 0.7065883827749112 -1.0590220207631201e-07 -0.0997071589246809 -2.1475999999999997 0.7065896072764537 0.7065885405663548 -1.0366130685172253e-07 -0.09970724775413015 -2.1477000000000004 0.7065897637512715 0.706588698285944 -1.0140712572090371e-07 -0.09970733655667367 -2.1478 0.7065899202028283 0.7065888559335569 -9.914018211064357e-08 -0.09970742533231954 -2.1479 0.7065900766312692 0.7065890135090778 -9.686100223022659e-08 -0.09970751408107592 -2.148 0.7065902330367333 0.7065891710123959 -9.457011494479889e-08 -0.09970760280295093 -2.1481 0.7065903894193543 0.7065893284434068 -9.226805166781538e-08 -0.09970769149795271 -2.1482 0.7065905457792596 0.7065894858020112 -8.995534622226187e-08 -0.09970778016608933 -2.1483000000000003 0.7065907021165716 0.7065896430881162 -8.763253472182653e-08 -0.0997078688073689 -2.1484 0.7065908584314062 0.7065898003016342 -8.53001554477345e-08 -0.0997079574217996 -2.1485 0.7065910147238739 0.7065899574424837 -8.295874872818465e-08 -0.09970804600938944 -2.1486 0.7065911709940792 0.7065901145105885 -8.060885680304108e-08 -0.0997081345701466 -2.1487000000000003 0.7065913272421211 0.7065902715058789 -7.825102371020881e-08 -0.0997082231040792 -2.1488 0.7065914834680924 0.7065904284282907 -7.588579515206001e-08 -0.09970831161119527 -2.1489000000000003 0.7065916396720797 0.7065905852777654 -7.351371836966658e-08 -0.0997084000915029 -2.149 0.7065917958541643 0.7065907420542511 -7.113534201573166e-08 -0.09970848854501026 -2.1491 0.7065919520144215 0.706590898757701 -6.875121603229159e-08 -0.09970857697172542 -2.1492000000000004 0.7065921081529205 0.7065910553880745 -6.636189151931066e-08 -0.09970866537165646 -2.1493 0.7065922642697245 0.7065912119453375 -6.3967920611082e-08 -0.09970875374481147 -2.1494 0.7065924203648907 0.7065913684294605 -6.156985634525602e-08 -0.09970884209119846 -2.1495 0.7065925764384708 0.7065915248404215 -5.916825253447083e-08 -0.0997089304108257 -2.1496 0.7065927324905104 0.7065916811782034 -5.6763663642970044e-08 -0.09970901870370112 -2.1497 0.7065928885210486 0.7065918374427951 -5.435664465346275e-08 -0.09970910696983284 -2.1498000000000004 0.7065930445301192 0.7065919936341922 -5.194775094395816e-08 -0.09970919520922897 -2.1499 0.7065932005177498 0.7065921497523954 -4.953753815690239e-08 -0.09970928342189755 -2.15 0.7065933564839619 0.7065923057974117 -4.712656207015841e-08 -0.09970937160784667 -2.1501 0.7065935124287711 0.7065924617692545 -4.4715378471834894e-08 -0.0997094597670844 -2.1502000000000003 0.7065936683521872 0.7065926176679422 -4.230454303099512e-08 -0.09970954789961878 -2.1503 0.7065938242542136 0.7065927734935001 -3.989461116714614e-08 -0.09970963600545789 -2.1504000000000003 0.7065939801348481 0.706592929245959 -3.748613792617893e-08 -0.09970972408460978 -2.1505 0.7065941359940825 0.7065930849253554 -3.507967785069781e-08 -0.0997098121370825 -2.1506 0.7065942918319026 0.7065932405317324 -3.267578485110882e-08 -0.09970990016288415 -2.1507 0.7065944476482886 0.7065933960651387 -3.027501208258988e-08 -0.0997099881620228 -2.1508000000000003 0.706594603443214 0.7065935515256289 -2.7877911812357326e-08 -0.09971007613450641 -2.1509 0.706594759216647 0.7065937069132633 -2.5485035295633174e-08 -0.09971016408034315 -2.151 0.7065949149685498 0.7065938622281085 -2.309693264814297e-08 -0.09971025199954098 -2.1511 0.7065950706988784 0.7065940174702368 -2.0714152723384088e-08 -0.09971033989210792 -2.1512000000000002 0.7065952264075832 0.7065941726397262 -1.8337242978401502e-08 -0.09971042775805211 -2.1513 0.7065953820946087 0.7065943277366611 -1.5966749356693954e-08 -0.09971051559738152 -2.1514 0.7065955377598936 0.7065944827611309 -1.3603216157242332e-08 -0.09971060341010421 -2.1515 0.7065956934033707 0.7065946377132317 -1.1247185910043256e-08 -0.09971069119622822 -2.1515999999999997 0.7065958490249669 0.7065947925930649 -8.899199255979484e-09 -0.09971077895576158 -2.1517000000000004 0.7065960046246036 0.7065949474007378 -6.559794818450371e-09 -0.09971086668871237 -2.1518 0.7065961602021962 0.7065951021363631 -4.229509082374905e-09 -0.09971095439508856 -2.1519 0.7065963157576542 0.70659525680006 -1.9088762636537693e-09 -0.09971104207489818 -2.152 0.7065964712908819 0.7065954113919524 4.015717957814302e-10 -0.09971112972814926 -2.1521 0.7065966268017774 0.7065955659121708 2.701305769348128e-09 -0.09971121735484981 -2.1522 0.7065967822902335 0.7065957203608508 4.989798957702463e-09 -0.09971130495500785 -2.1523000000000003 0.7065969377561374 0.7065958747381339 7.266527405833112e-09 -0.09971139252863147 -2.1524 0.7065970931993704 0.7065960290441669 9.530970030563468e-09 -0.09971148007572855 -2.1525 0.7065972486198082 0.7065961832791021 1.1782608737645472e-08 -0.09971156759630717 -2.1526 0.7065974040173213 0.7065963374430982 1.4020928532781918e-08 -0.09971165509037538 -2.1527000000000003 0.7065975593917748 0.7065964915363183 1.624541765780224e-08 -0.09971174255794117 -2.1528 0.706597714743028 0.7065966455589314 1.8455567686072316e-08 -0.09971182999901251 -2.1529000000000003 0.7065978700709349 0.706596799511112 2.0650873649129264e-08 -0.09971191741359745 -2.153 0.7065980253753439 0.7065969533930395 2.2830834150305845e-08 -0.09971200480170388 -2.1531 0.7065981806560986 0.7065971072048994 2.4994951483559014e-08 -0.09971209216333993 -2.1532000000000004 0.7065983359130366 0.7065972609468818 2.7142731741022774e-08 -0.09971217949851352 -2.1533 0.7065984911459909 0.7065974146191825 2.9273684927499932e-08 -0.09971226680723268 -2.1534 0.706598646354789 0.7065975682220023 3.1387325075821204e-08 -0.09971235408950536 -2.1535 0.706598801539253 0.706597721755547 3.34831703491939e-08 -0.09971244134533958 -2.1536 0.7065989566992001 0.7065978752200279 3.556074315742841e-08 -0.09971252857474328 -2.1537 0.7065991118344428 0.7065980286156611 3.761957027489937e-08 -0.0997126157777245 -2.1538000000000004 0.706599266944788 0.7065981819426678 3.9659182925547154e-08 -0.09971270295429117 -2.1539 0.706599422030038 0.7065983352012742 4.16791169060432e-08 -0.09971279010445137 -2.154 0.7065995770899898 0.7065984883917115 4.367891268119983e-08 -0.09971287722821298 -2.1541 0.7065997321244355 0.7065986415142154 4.565811551060506e-08 -0.09971296432558398 -2.1542000000000003 0.7065998871331628 0.7065987945690269 4.761627551974623e-08 -0.09971305139657233 -2.1543 0.7066000421159544 0.7065989475563914 4.95529478283796e-08 -0.09971313844118607 -2.1544 0.7066001970725885 0.7065991004765593 5.146769263553175e-08 -0.09971322545943309 -2.1545 0.7066003520028381 0.7065992533297853 5.336007533225662e-08 -0.0997133124513214 -2.1546 0.706600506906472 0.706599406116329 5.52296665814328e-08 -0.09971339941685892 -2.1547 0.7066006617832546 0.7065995588364545 5.707604244266362e-08 -0.09971348635605366 -2.1548000000000003 0.7066008166329455 0.7065997114904303 5.889878443993135e-08 -0.09971357326891354 -2.1549 0.7066009714552998 0.7065998640785291 6.069747967261951e-08 -0.09971366015544653 -2.155 0.7066011262500687 0.7066000166010284 6.247172090224906e-08 -0.09971374701566058 -2.1551 0.7066012810169984 0.70660016905821 6.422110666350067e-08 -0.09971383384956362 -2.1552000000000002 0.7066014357558315 0.7066003214503596 6.594524132493007e-08 -0.0997139206571636 -2.1553 0.7066015904663061 0.706600473777767 6.764373519305145e-08 -0.09971400743846853 -2.1554 0.7066017451481565 0.7066006260407263 6.931620460601251e-08 -0.09971409419348627 -2.1555 0.7066018998011123 0.7066007782395358 7.096227201339178e-08 -0.09971418092222481 -2.1555999999999997 0.7066020544248999 0.7066009303744976 7.258156605252641e-08 -0.09971426762469204 -2.1557000000000004 0.7066022090192411 0.7066010824459177 7.417372165953451e-08 -0.09971435430089592 -2.1558 0.7066023635838545 0.7066012344541059 7.573838011268319e-08 -0.09971444095084442 -2.1559 0.7066025181184545 0.7066013863993759 7.727518915381926e-08 -0.09971452757454542 -2.156 0.7066026726227519 0.7066015382820447 7.878380303867616e-08 -0.09971461417200687 -2.1561 0.7066028270964537 0.7066016901024338 8.02638826253449e-08 -0.09971470074323668 -2.1562 0.7066029815392636 0.7066018418608674 8.171509545754074e-08 -0.09971478728824282 -2.1563000000000003 0.7066031359508818 0.7066019935576734 8.313711581491023e-08 -0.09971487380703314 -2.1564 0.7066032903310048 0.7066021451931832 8.452962480670623e-08 -0.0997149602996156 -2.1565 0.706603444679326 0.7066022967677315 8.589231044811574e-08 -0.09971504676599807 -2.1566 0.7066035989955355 0.7066024482816563 8.722486771924054e-08 -0.09971513320618852 -2.1567000000000003 0.7066037532793203 0.7066025997352989 8.852699862407776e-08 -0.09971521962019486 -2.1568 0.7066039075303644 0.7066027511290034 8.979841227552132e-08 -0.09971530600802497 -2.1569000000000003 0.7066040617483481 0.7066029024631173 9.103882495087312e-08 -0.0997153923696868 -2.157 0.7066042159329493 0.7066030537379907 9.224796014214998e-08 -0.0997154787051882 -2.1571 0.7066043700838429 0.7066032049539769 9.342554866190178e-08 -0.0997155650145371 -2.1572000000000005 0.706604524200701 0.7066033561114315 9.457132866749762e-08 -0.0997156512977414 -2.1573 0.706604678283193 0.7066035072107133 9.568504568888136e-08 -0.099715737554809 -2.1574 0.7066048323309855 0.7066036582521836 9.676645275694118e-08 -0.09971582378574777 -2.1575 0.7066049863437427 0.7066038092362061 9.781531042432623e-08 -0.09971590999056558 -2.1576 0.7066051403211265 0.7066039601631472 9.88313867966717e-08 -0.09971599616927039 -2.1577 0.7066052942627958 0.7066041110333754 9.981445759504881e-08 -0.09971608232187001 -2.1578000000000004 0.7066054481684081 0.7066042618472621 1.007643062392316e-07 -0.09971616844837243 -2.1579 0.7066056020376174 0.7066044126051804 1.0168072386504412e-07 -0.09971625454878542 -2.158 0.7066057558700769 0.7066045633075055 1.0256350936599379e-07 -0.09971634062311696 -2.1581 0.7066059096654368 0.7066047139546148 1.0341246945919091e-07 -0.09971642667137487 -2.1582000000000003 0.7066060634233458 0.7066048645468879 1.0422741869228758e-07 -0.09971651269356702 -2.1583 0.7066062171434502 0.7066050150847061 1.050081795232749e-07 -0.09971659868970134 -2.1584 0.7066063708253953 0.7066051655684522 1.057545823378303e-07 -0.09971668465978566 -2.1585 0.7066065244688238 0.7066053159985111 1.0646646550135919e-07 -0.09971677060382778 -2.1586 0.7066066780733775 0.7066054663752692 1.0714367535205604e-07 -0.09971685652183568 -2.1587 0.7066068316386961 0.7066056166991146 1.077860662841712e-07 -0.09971694241381718 -2.1588000000000003 0.706606985164418 0.7066057669704371 1.0839350076882748e-07 -0.09971702827978018 -2.1589 0.7066071386501802 0.7066059171896268 1.0896584935748965e-07 -0.09971711411973244 -2.159 0.7066072920956187 0.7066060673570762 1.0950299073400616e-07 -0.09971719993368192 -2.1591 0.7066074455003678 0.7066062174731785 1.1000481171807852e-07 -0.0997172857216364 -2.1592000000000002 0.706607598864061 0.7066063675383281 1.1047120733118088e-07 -0.09971737148360377 -2.1593 0.706607752186331 0.7066065175529206 1.1090208076186547e-07 -0.09971745721959188 -2.1594 0.7066079054668088 0.706606667517352 1.1129734342474329e-07 -0.09971754292960859 -2.1595 0.7066080587051253 0.7066068174320199 1.1165691497089236e-07 -0.09971762861366168 -2.1595999999999997 0.7066082119009102 0.7066069672973221 1.1198072329132724e-07 -0.09971771427175906 -2.1597000000000004 0.7066083650537929 0.7066071171136572 1.1226870455169347e-07 -0.09971779990390857 -2.1598 0.7066085181634016 0.7066072668814245 1.1252080317145086e-07 -0.09971788551011804 -2.1599 0.7066086712293649 0.7066074166010236 1.1273697188285414e-07 -0.09971797109039526 -2.16 0.7066088242513098 0.7066075662728546 1.1291717169278903e-07 -0.09971805664474809 -2.1601 0.7066089772288642 0.7066077158973181 1.1306137191052779e-07 -0.09971814217318438 -2.1602 0.706609130161655 0.7066078654748145 1.1316955015813757e-07 -0.09971822767571198 -2.1603000000000003 0.7066092830493094 0.7066080150057448 1.1324169236354154e-07 -0.09971831315233867 -2.1604 0.7066094358914539 0.7066081644905096 1.1327779275704941e-07 -0.09971839860307229 -2.1605 0.706609588687716 0.7066083139295096 1.1327785387829636e-07 -0.09971848402792065 -2.1606 0.7066097414377224 0.7066084633231458 1.1324188656930412e-07 -0.09971856942689156 -2.1607000000000003 0.7066098941411003 0.7066086126718182 1.1316990998141985e-07 -0.09971865479999287 -2.1608 0.7066100467974777 0.7066087619759271 1.130619515544995e-07 -0.09971874014723237 -2.1609000000000003 0.7066101994064824 0.7066089112358722 1.1291804699956054e-07 -0.09971882546861788 -2.161 0.7066103519677429 0.7066090604520529 1.1273824029878199e-07 -0.09971891076415723 -2.1611 0.7066105044808881 0.7066092096248673 1.1252258371591273e-07 -0.09971899603385816 -2.1612000000000005 0.7066106569455481 0.706609358754714 1.1227113775463815e-07 -0.09971908127772856 -2.1613 0.706610809361353 0.7066095078419896 1.1198397113776348e-07 -0.09971916649577617 -2.1614 0.7066109617279343 0.7066096568870908 1.1166116079333599e-07 -0.09971925168800883 -2.1615 0.7066111140449242 0.706609805890413 1.1130279186158387e-07 -0.09971933685443435 -2.1616 0.7066112663119558 0.7066099548523503 1.1090895763940511e-07 -0.09971942199506045 -2.1617 0.7066114185286635 0.7066101037732966 1.1047975956302025e-07 -0.09971950710989498 -2.1618000000000004 0.7066115706946828 0.7066102526536437 1.1001530719409458e-07 -0.09971959219894574 -2.1619 0.7066117228096507 0.7066104014937824 1.0951571817463535e-07 -0.09971967726222053 -2.162 0.7066118748732049 0.7066105502941022 1.0898111822699175e-07 -0.09971976229972707 -2.1620999999999997 0.7066120268849853 0.706610699054991 1.0841164110181323e-07 -0.09971984731147318 -2.1622000000000003 0.7066121788446331 0.7066108477768355 1.0780742852600778e-07 -0.09971993229746667 -2.1623 0.7066123307517909 0.7066109964600203 1.0716863019233358e-07 -0.09972001725771529 -2.1624 0.7066124826061028 0.7066111451049286 1.0649540374899069e-07 -0.09972010219222677 -2.1625 0.7066126344072156 0.706611293711942 1.0578791468512927e-07 -0.099720187101009 -2.1626 0.706612786154777 0.7066114422814396 1.0504633637248295e-07 -0.09972027198406963 -2.1627 0.7066129378484372 0.7066115908137991 1.0427084997516323e-07 -0.0997203568414165 -2.1628000000000003 0.7066130894878484 0.706611739309396 1.0346164441496497e-07 -0.09972044167305741 -2.1629 0.7066132410726644 0.7066118877686035 1.0261891631585529e-07 -0.09972052647900004 -2.163 0.7066133926025424 0.7066120361917927 1.017428699727485e-07 -0.09972061125925222 -2.1631 0.7066135440771403 0.7066121845793325 1.0083371731334223e-07 -0.09972069601382166 -2.1632000000000002 0.7066136954961193 0.7066123329315895 9.989167781485064e-08 -0.09972078074271618 -2.1633 0.7066138468591432 0.7066124812489275 9.891697847277947e-08 -0.09972086544594344 -2.1634 0.7066139981658777 0.7066126295317081 9.790985373847594e-08 -0.0997209501235113 -2.1635 0.7066141494159915 0.70661277778029 9.687054545667872e-08 -0.09972103477542746 -2.1635999999999997 0.7066143006091561 0.7066129259950296 9.579930285164018e-08 -0.09972111940169966 -2.1637000000000004 0.7066144517450454 0.7066130741762799 9.469638237794009e-08 -0.09972120400233565 -2.1638 0.7066146028233364 0.7066132223243918 9.356204774130239e-08 -0.09972128857734319 -2.1639 0.7066147538437089 0.706613370439713 9.239656981879785e-08 -0.09972137312673005 -2.164 0.7066149048058457 0.7066135185225877 9.120022655823012e-08 -0.0997214576505039 -2.1641 0.7066150557094326 0.7066136665733578 8.997330295384964e-08 -0.09972154214867253 -2.1642 0.7066152065541585 0.7066138145923617 8.871609094920907e-08 -0.09972162662124365 -2.1643000000000003 0.706615357339716 0.7066139625799344 8.742888938512161e-08 -0.09972171106822499 -2.1644 0.7066155080658005 0.7066141105364079 8.611200393374152e-08 -0.09972179548962429 -2.1645 0.7066156587321111 0.7066142584621105 8.476574699274597e-08 -0.09972187988544928 -2.1646 0.7066158093383496 0.7066144063573674 8.339043764543641e-08 -0.09972196425570769 -2.1647000000000003 0.7066159598842221 0.7066145542225003 8.198640158788018e-08 -0.09972204860040723 -2.1648 0.7066161103694382 0.7066147020578271 8.055397102309236e-08 -0.09972213291955566 -2.1649000000000003 0.7066162607937108 0.7066148498636621 7.909348458817744e-08 -0.09972221721316066 -2.165 0.7066164111567561 0.7066149976403159 7.760528730055283e-08 -0.09972230148122992 -2.1651 0.7066165614582955 0.7066151453880956 7.608973045386547e-08 -0.09972238572377125 -2.1652000000000005 0.706616711698053 0.7066152931073035 7.454717153992929e-08 -0.09972246994079229 -2.1653000000000002 0.7066168618757567 0.7066154407982393 7.297797417586682e-08 -0.09972255413230073 -2.1654 0.7066170119911391 0.7066155884611978 7.138250798614798e-08 -0.09972263829830433 -2.1655 0.7066171620439365 0.70661573609647 6.976114856616089e-08 -0.09972272243881075 -2.1656 0.7066173120338891 0.7066158837043427 6.811427733476039e-08 -0.0997228065538277 -2.1657 0.7066174619607417 0.7066160312850989 6.644228148396103e-08 -0.09972289064336293 -2.1658000000000004 0.7066176118242427 0.7066161788390171 6.474555390260928e-08 -0.09972297470742407 -2.1659 0.7066177616241456 0.7066163263663713 6.30244930306667e-08 -0.09972305874601885 -2.166 0.7066179113602077 0.7066164738674316 6.127950281410721e-08 -0.099723142759155 -2.1660999999999997 0.7066180610321906 0.7066166213424634 5.9510992578282185e-08 -0.09972322674684014 -2.1662000000000003 0.7066182106398606 0.7066167687917277 5.7719376958531576e-08 -0.09972331070908202 -2.1663 0.7066183601829885 0.706616916215481 5.590507578048798e-08 -0.09972339464588827 -2.1664 0.7066185096613498 0.706617063613975 5.4068513971605725e-08 -0.09972347855726658 -2.1665 0.7066186590747242 0.7066172109874571 5.22101214657511e-08 -0.09972356244322467 -2.1666 0.7066188084228966 0.7066173583361702 5.033033309564949e-08 -0.09972364630377022 -2.1667 0.7066189577056563 0.7066175056603519 4.842958849400614e-08 -0.0997237301389109 -2.1668000000000003 0.7066191069227972 0.706617652960235 4.650833199115745e-08 -0.09972381394865432 -2.1669 0.7066192560741185 0.7066178002360483 4.45670125109876e-08 -0.09972389773300826 -2.167 0.7066194051594239 0.7066179474880148 4.260608346337569e-08 -0.09972398149198033 -2.1671 0.7066195541785223 0.7066180947163532 4.0626002641847014e-08 -0.09972406522557822 -2.1672000000000002 0.7066197031312271 0.7066182419212768 3.8627232112550813e-08 -0.0997241489338096 -2.1673 0.7066198520173574 0.7066183891029938 3.661023812578934e-08 -0.09972423261668206 -2.1674 0.7066200008367365 0.7066185362617082 3.4575490961627486e-08 -0.09972431627420333 -2.1675 0.7066201495891935 0.706618683397618 3.252346487785107e-08 -0.09972439990638106 -2.1675999999999997 0.7066202982745624 0.7066188305109163 3.045463795731118e-08 -0.09972448351322291 -2.1677000000000004 0.7066204468926822 0.7066189776017913 2.8369492009044928e-08 -0.09972456709473652 -2.1678 0.7066205954433975 0.7066191246704252 2.626851246419204e-08 -0.0997246506509295 -2.1679 0.7066207439265578 0.7066192717169961 2.4152188254564222e-08 -0.0997247341818096 -2.168 0.7066208923420181 0.706619418741676 2.2021011694683956e-08 -0.09972481768738439 -2.1681 0.7066210406896386 0.7066195657446317 1.9875478382905265e-08 -0.09972490116766156 -2.1682 0.7066211889692849 0.706619712726025 1.771608707130945e-08 -0.09972498462264873 -2.1683000000000003 0.7066213371808281 0.7066198596860114 1.5543339562489045e-08 -0.09972506805235354 -2.1684 0.7066214853241443 0.706620006624742 1.335774057684147e-08 -0.09972515145678362 -2.1685 0.7066216333991157 0.706620153542362 1.115979764588354e-08 -0.0997252348359466 -2.1686 0.7066217814056293 0.7066203004390109 8.950020999494435e-09 -0.09972531818985014 -2.1687000000000003 0.706621929343578 0.7066204473148234 6.72892343581144e-09 -0.09972540151850189 -2.1688 0.7066220772128602 0.7066205941699277 4.497020203268753e-09 -0.0997254848219094 -2.1689000000000003 0.70662222501338 0.7066207410044472 2.2548288973814334e-09 -0.09972556810008038 -2.169 0.7066223727450467 0.7066208878184994 2.869316763354224e-12 -0.09972565135302242 -2.1691 0.7066225204077756 0.7066210346121962 -2.2583366366193958e-09 -0.09972573458074313 -2.1692000000000005 0.7066226680014873 0.7066211813856436 -4.5282650927569446e-09 -0.09972581778325017 -2.1693000000000002 0.7066228155261082 0.7066213281389426 -6.806390326352663e-09 -0.09972590096055112 -2.1694 0.7066229629815701 0.7066214748721882 -9.092184882590615e-09 -0.0997259841126536 -2.1695 0.706623110367811 0.7066216215854692 -1.1385119698566204e-08 -0.09972606723956519 -2.1696 0.7066232576847742 0.7066217682788696 -1.368466422298209e-08 -0.09972615034129355 -2.1697 0.7066234049324089 0.7066219149524671 -1.599028654538509e-08 -0.0997262334178463 -2.1698000000000004 0.7066235521106696 0.706622061606334 -1.830145351195897e-08 -0.09972631646923097 -2.1699 0.7066236992195174 0.7066222082405365 -2.061763084912349e-08 -0.09972639949545525 -2.17 0.7066238462589183 0.7066223548551351 -2.2938283293638673e-08 -0.09972648249652669 -2.1700999999999997 0.7066239932288443 0.7066225014501852 -2.5262874710132305e-08 -0.0997265654724529 -2.1702000000000004 0.7066241401292734 0.7066226480257356 -2.7590868216000042e-08 -0.09972664842324153 -2.1703 0.7066242869601893 0.7066227945818295 -2.9921726309124416e-08 -0.0997267313489001 -2.1704 0.706624433721581 0.7066229411185048 -3.22549109877876e-08 -0.09972681424943625 -2.1705 0.7066245804134441 0.706623087635793 -3.458988387448729e-08 -0.09972689712485755 -2.1706 0.706624727035779 0.7066232341337201 -3.692610634408941e-08 -0.0997269799751716 -2.1707 0.7066248735885929 0.7066233806123061 -3.9263039642981924e-08 -0.09972706280038594 -2.1708000000000003 0.7066250200718979 0.706623527071566 -4.160014501852858e-08 -0.09972714560050822 -2.1709 0.7066251664857124 0.7066236735115078 -4.3936883839035875e-08 -0.09972722837554596 -2.171 0.7066253128300605 0.7066238199321344 -4.6272717720008405e-08 -0.09972731112550676 -2.1711 0.7066254591049719 0.706623966333443 -4.8607108647314226e-08 -0.0997273938503982 -2.1712000000000002 0.7066256053104821 0.7066241127154251 -5.093951910316915e-08 -0.09972747655022786 -2.1713 0.7066257514466328 0.706624259078066 -5.326941218426057e-08 -0.09972755922500331 -2.1714 0.7066258975134706 0.7066244054213452 -5.5596251732339605e-08 -0.0997276418747321 -2.1715 0.706626043511049 0.706624551745237 -5.7919502451314955e-08 -0.09972772449942184 -2.1715999999999998 0.7066261894394259 0.7066246980497097 -6.023863003724872e-08 -0.09972780709908007 -2.1717000000000004 0.7066263352986659 0.7066248443347258 -6.25531012925229e-08 -0.09972788967371436 -2.1718 0.7066264810888387 0.7066249906002421 -6.486238425702784e-08 -0.09972797222333224 -2.1719 0.7066266268100202 0.7066251368462095 -6.716594832438874e-08 -0.0997280547479413 -2.172 0.7066267724622919 0.7066252830725738 -6.946326436534783e-08 -0.09972813724754909 -2.1721 0.7066269180457403 0.7066254292792746 -7.175380485483288e-08 -0.09972821972216316 -2.1722 0.7066270635604586 0.7066255754662459 -7.403704397864266e-08 -0.09972830217179104 -2.1723000000000003 0.7066272090065446 0.7066257216334164 -7.631245777005649e-08 -0.09972838459644032 -2.1724 0.7066273543841024 0.706625867780709 -7.857952422519326e-08 -0.09972846699611852 -2.1725 0.7066274996932416 0.7066260139080409 -8.083772341533485e-08 -0.0997285493708332 -2.1726 0.7066276449340768 0.7066261600153239 -8.308653761269352e-08 -0.09972863172059188 -2.1727000000000003 0.7066277901067288 0.7066263061024642 -8.532545141531206e-08 -0.09972871404540212 -2.1728 0.7066279352113234 0.7066264521693627 -8.755395184724402e-08 -0.09972879634527144 -2.1729000000000003 0.7066280802479921 0.7066265982159144 -8.977152849386216e-08 -0.0997288786202074 -2.173 0.7066282252168719 0.7066267442420093 -9.197767361114606e-08 -0.09972896087021753 -2.1731 0.7066283701181049 0.7066268902475318 -9.417188223757172e-08 -0.09972904309530933 -2.1732000000000005 0.7066285149518392 0.7066270362323606 -9.635365231901172e-08 -0.09972912529549038 -2.1733000000000002 0.7066286597182276 0.7066271821963693 -9.852248481889009e-08 -0.09972920747076815 -2.1734 0.7066288044174288 0.7066273281394266 -1.0067788383354148e-07 -0.09972928962115021 -2.1735 0.7066289490496062 0.7066274740613951 -1.0281935669369247e-07 -0.09972937174664409 -2.1736 0.7066290936149284 0.7066276199621329 -1.049464141032394e-07 -0.09972945384725725 -2.1737 0.70662923811357 0.7066277658414923 -1.0705857022251519e-07 -0.09972953592299721 -2.1738000000000004 0.7066293825457102 0.7066279116993206 -1.0915534280186295e-07 -0.09972961797387155 -2.1739 0.706629526911533 0.7066280575354602 -1.1123625327964792e-07 -0.09972969999988772 -2.174 0.7066296712112283 0.7066282033497483 -1.1330082688373877e-07 -0.0997297820010533 -2.1740999999999997 0.7066298154449906 0.7066283491420168 -1.1534859276421394e-07 -0.09972986397737571 -2.1742000000000004 0.7066299596130194 0.7066284949120931 -1.1737908407923048e-07 -0.09972994592886256 -2.1743 0.7066301037155192 0.7066286406597988 -1.1939183810691367e-07 -0.09973002785552125 -2.1744 0.7066302477526991 0.7066287863849514 -1.2138639635984882e-07 -0.09973010975735935 -2.1745 0.7066303917247736 0.7066289320873633 -1.2336230467355214e-07 -0.09973019163438433 -2.1746 0.7066305356319619 0.7066290777668418 -1.2531911331922774e-07 -0.0997302734866037 -2.1747 0.7066306794744877 0.7066292234231898 -1.2725637711305526e-07 -0.09973035531402491 -2.1748000000000003 0.7066308232525795 0.7066293690562051 -1.2917365549598714e-07 -0.09973043711665554 -2.1749 0.7066309669664708 0.7066295146656811 -1.3107051265864866e-07 -0.09973051889450302 -2.175 0.7066311106163993 0.7066296602514066 -1.329465176280742e-07 -0.09973060064757483 -2.1751 0.7066312542026073 0.7066298058131658 -1.348012443544433e-07 -0.09973068237587851 -2.1752000000000002 0.706631397725342 0.7066299513507377 -1.3663427183424615e-07 -0.09973076407942148 -2.1753 0.7066315411848543 0.7066300968638981 -1.3844518418661134e-07 -0.09973084575821121 -2.1754000000000002 0.7066316845814005 0.7066302423524176 -1.402335707504504e-07 -0.0997309274122553 -2.1755 0.7066318279152406 0.7066303878160625 -1.4199902618333704e-07 -0.09973100904156113 -2.1755999999999998 0.7066319711866385 0.7066305332545947 -1.4374115054824332e-07 -0.09973109064613613 -2.1757000000000004 0.7066321143958635 0.7066306786677725 -1.4545954940027583e-07 -0.09973117222598789 -2.1758 0.706632257543188 0.7066308240553494 -1.4715383388208547e-07 -0.09973125378112382 -2.1759 0.706632400628889 0.706630969417075 -1.488236208227467e-07 -0.0997313353115514 -2.176 0.7066325436532473 0.7066311147526947 -1.504685327880645e-07 -0.09973141681727804 -2.1761 0.706632686616548 0.7066312600619502 -1.5208819821761754e-07 -0.09973149829831127 -2.1762 0.7066328295190796 0.7066314053445792 -1.5368225146292214e-07 -0.09973157975465853 -2.1763000000000003 0.706632972361135 0.7066315506003158 -1.5525033288978085e-07 -0.09973166118632731 -2.1764 0.7066331151430105 0.7066316958288894 -1.5679208896501873e-07 -0.09973174259332503 -2.1765 0.7066332578650061 0.7066318410300266 -1.5830717232240277e-07 -0.0997318239756591 -2.1766 0.7066334005274258 0.70663198620345 -1.5979524184590865e-07 -0.09973190533333706 -2.1767000000000003 0.706633543130577 0.7066321313488788 -1.6125596276513054e-07 -0.09973198666636635 -2.1768 0.7066336856747706 0.706632276466028 -1.6268900668303665e-07 -0.09973206797475434 -2.1769000000000003 0.7066338281603208 0.70663242155461 -1.640940517060735e-07 -0.09973214925850854 -2.177 0.7066339705875455 0.7066325666143336 -1.6547078247712566e-07 -0.09973223051763641 -2.1771 0.7066341129567655 0.706632711644904 -1.6681889026051722e-07 -0.09973231175214534 -2.1772000000000005 0.706634255268305 0.7066328566460237 -1.6813807300793127e-07 -0.09973239296204282 -2.1773000000000002 0.7066343975224916 0.7066330016173912 -1.6942803543473772e-07 -0.09973247414733621 -2.1774 0.7066345397196554 0.7066331465587026 -1.706884890685656e-07 -0.09973255530803304 -2.1775 0.7066346818601299 0.7066332914696509 -1.7191915233603916e-07 -0.09973263644414064 -2.1776 0.706634823944252 0.7066334363499257 -1.7311975060961549e-07 -0.09973271755566653 -2.1777 0.7066349659723605 0.7066335811992144 -1.742900162700345e-07 -0.09973279864261807 -2.1778000000000004 0.7066351079447977 0.7066337260172012 -1.7542968877570786e-07 -0.09973287970500273 -2.1779 0.706635249861908 0.7066338708035675 -1.7653851470608717e-07 -0.0997329607428279 -2.178 0.7066353917240391 0.7066340155579924 -1.7761624783452223e-07 -0.09973304175610102 -2.1780999999999997 0.7066355335315407 0.7066341602801524 -1.7866264916469032e-07 -0.09973312274482951 -2.1782000000000004 0.7066356752847653 0.7066343049697211 -1.796774869930462e-07 -0.09973320370902079 -2.1783 0.7066358169840679 0.7066344496263701 -1.8066053696433326e-07 -0.09973328464868225 -2.1784 0.7066359586298051 0.7066345942497686 -1.8161158212362527e-07 -0.09973336556382131 -2.1785 0.7066361002223367 0.7066347388395837 -1.82530412937143e-07 -0.09973344645444543 -2.1786 0.706636241762024 0.7066348833954801 -1.834168273824599e-07 -0.09973352732056195 -2.1787 0.7066363832492306 0.7066350279171201 -1.8427063094156315e-07 -0.0997336081621783 -2.1788000000000003 0.706636524684322 0.7066351724041648 -1.8509163669105932e-07 -0.0997336889793019 -2.1789 0.7066366660676657 0.7066353168562729 -1.8587966532992994e-07 -0.09973376977194014 -2.179 0.706636807399631 0.7066354612731012 -1.866345451725926e-07 -0.09973385054010037 -2.1791 0.7066369486805889 0.706635605654305 -1.8735611227033155e-07 -0.09973393128379004 -2.1792000000000002 0.7066370899109121 0.7066357499995379 -1.8804421035578667e-07 -0.09973401200301657 -2.1793 0.7066372310909749 0.7066358943084516 -1.886986909678534e-07 -0.09973409269778728 -2.1794000000000002 0.706637372221153 0.7066360385806971 -1.89319413413519e-07 -0.09973417336810964 -2.1795 0.7066375133018237 0.7066361828159228 -1.8990624481990404e-07 -0.09973425401399098 -2.1795999999999998 0.706637654333365 0.7066363270137765 -1.904590601620182e-07 -0.09973433463543864 -2.1797000000000004 0.7066377953161571 0.7066364711739047 -1.9097774231133235e-07 -0.09973441523246009 -2.1798 0.706637936250581 0.7066366152959529 -1.9146218201149257e-07 -0.0997344958050627 -2.1799 0.7066380771370184 0.706636759379565 -1.9191227795464783e-07 -0.09973457635325383 -2.18 0.7066382179758524 0.7066369034243845 -1.9232793677104176e-07 -0.09973465687704086 -2.1801 0.7066383587674667 0.7066370474300534 -1.9270907304289042e-07 -0.0997347373764312 -2.1802 0.706638499512246 0.7066371913962132 -1.9305560936336286e-07 -0.09973481785143212 -2.1803000000000003 0.7066386402105758 0.7066373353225046 -1.9336747629494777e-07 -0.09973489830205108 -2.1804 0.706638780862842 0.7066374792085679 -1.93644612435373e-07 -0.09973497872829541 -2.1805 0.7066389214694313 0.7066376230540425 -1.938869643690333e-07 -0.09973505913017253 -2.1806 0.7066390620307307 0.7066377668585676 -1.9409448675025698e-07 -0.09973513950768972 -2.1807000000000003 0.7066392025471275 0.7066379106217817 -1.942671422512643e-07 -0.09973521986085439 -2.1808 0.7066393430190097 0.7066380543433228 -1.9440490158645352e-07 -0.09973530018967386 -2.1809000000000003 0.7066394834467651 0.7066381980228296 -1.9450774355056488e-07 -0.09973538049415553 -2.181 0.7066396238307819 0.7066383416599397 -1.9457565495276108e-07 -0.09973546077430673 -2.1811 0.7066397641714479 0.7066384852542913 -1.9460863068948564e-07 -0.09973554103013482 -2.1812000000000005 0.7066399044691517 0.7066386288055224 -1.9460667371323792e-07 -0.0997356212616472 -2.1813000000000002 0.7066400447242809 0.706638772313271 -1.9456979497706195e-07 -0.09973570146885116 -2.1814 0.7066401849372231 0.7066389157771753 -1.9449801353516039e-07 -0.09973578165175402 -2.1815 0.7066403251083659 0.7066390591968743 -1.9439135644575e-07 -0.0997358618103632 -2.1816 0.7066404652380964 0.7066392025720065 -1.9424985880575618e-07 -0.09973594194468599 -2.1817 0.7066406053268008 0.7066393459022118 -1.9407356372305729e-07 -0.0997360220547297 -2.1818 0.7066407453748653 0.7066394891871304 -1.9386252233383194e-07 -0.09973610214050177 -2.1819 0.706640885382675 0.7066396324264024 -1.936167937643951e-07 -0.0997361822020094 -2.182 0.7066410253506146 0.7066397756196696 -1.9333644508609527e-07 -0.09973626223926 -2.1820999999999997 0.7066411652790681 0.7066399187665744 -1.9302155134653942e-07 -0.09973634225226094 -2.1822000000000004 0.7066413051684178 0.7066400618667593 -1.9267219554877646e-07 -0.09973642224101945 -2.1823 0.7066414450190458 0.706640204919869 -1.9228846858190818e-07 -0.09973650220554287 -2.1824 0.706641584831333 0.7066403479255484 -1.9187046925925322e-07 -0.09973658214583858 -2.1825 0.7066417246056589 0.7066404908834443 -1.9141830424895812e-07 -0.09973666206191392 -2.1826 0.706641864342402 0.7066406337932037 -1.9093208805318063e-07 -0.09973674195377613 -2.1827 0.7066420040419389 0.7066407766544758 -1.9041194300115083e-07 -0.09973682182143255 -2.1828000000000003 0.7066421437046458 0.706640919466911 -1.8985799917631274e-07 -0.09973690166489056 -2.1829 0.7066422833308966 0.7066410622301609 -1.8927039445795768e-07 -0.09973698148415741 -2.183 0.7066424229210637 0.7066412049438786 -1.8864927441020196e-07 -0.09973706127924038 -2.1831 0.706642562475518 0.7066413476077196 -1.879947922819869e-07 -0.09973714105014683 -2.1832000000000003 0.7066427019946288 0.7066414902213407 -1.87307108961976e-07 -0.09973722079688407 -2.1833 0.7066428414787633 0.7066416327844002 -1.8658639295426882e-07 -0.0997373005194594 -2.1834000000000002 0.706642980928287 0.7066417752965586 -1.858328203194204e-07 -0.0997373802178801 -2.1835 0.7066431203435634 0.7066419177574785 -1.8504657462239948e-07 -0.09973745989215348 -2.1835999999999998 0.7066432597249535 0.7066420601668243 -1.842278469221803e-07 -0.09973753954228681 -2.1837000000000004 0.7066433990728167 0.7066422025242627 -1.8337683569541463e-07 -0.09973761916828744 -2.1838 0.7066435383875098 0.7066423448294625 -1.824937468121457e-07 -0.09973769877016261 -2.1839 0.7066436776693878 0.7066424870820951 -1.8157879345948036e-07 -0.09973777834791966 -2.184 0.706643816918803 0.706642629281834 -1.8063219609995573e-07 -0.09973785790156585 -2.1841 0.7066439561361048 0.706642771428355 -1.7965418244725306e-07 -0.09973793743110845 -2.1842 0.706644095321641 0.7066429135213365 -1.7864498735170597e-07 -0.09973801693655476 -2.1843000000000004 0.7066442344757558 0.7066430555604599 -1.7760485281417826e-07 -0.09973809641791205 -2.1844 0.7066443735987916 0.706643197545409 -1.765340278611638e-07 -0.09973817587518764 -2.1845 0.7066445126910874 0.7066433394758702 -1.754327685447865e-07 -0.09973825530838876 -2.1846 0.7066446517529796 0.7066434813515332 -1.7430133783177815e-07 -0.09973833471752269 -2.1847000000000003 0.7066447907848017 0.7066436231720903 -1.7314000557225318e-07 -0.09973841410259675 -2.1848 0.706644929786884 0.7066437649372362 -1.719490484389935e-07 -0.09973849346361813 -2.1849000000000003 0.7066450687595544 0.7066439066466699 -1.7072874981816089e-07 -0.09973857280059419 -2.185 0.7066452077031367 0.7066440483000928 -1.6947939981103166e-07 -0.09973865211353214 -2.1851 0.7066453466179523 0.7066441898972092 -1.682012950986883e-07 -0.09973873140243925 -2.1852000000000005 0.7066454855043189 0.7066443314377273 -1.6689473889691664e-07 -0.09973881066732279 -2.1853000000000002 0.706645624362551 0.706644472921358 -1.65560040911103e-07 -0.09973888990819 -2.1854 0.7066457631929599 0.7066446143478164 -1.6419751721480358e-07 -0.0997389691250482 -2.1855 0.7066459019958531 0.7066447557168203 -1.6280749022198893e-07 -0.09973904831790459 -2.1856 0.7066460407715345 0.7066448970280913 -1.613902885638785e-07 -0.09973912748676643 -2.1857 0.7066461795203047 0.7066450382813548 -1.5994624706291982e-07 -0.09973920663164099 -2.1858 0.7066463182424604 0.70664517947634 -1.58475706604419e-07 -0.09973928575253549 -2.1859 0.7066464569382946 0.7066453206127787 -1.56979014084499e-07 -0.09973936484945717 -2.186 0.706646595608097 0.706645461690408 -1.554565223181592e-07 -0.0997394439224133 -2.1860999999999997 0.7066467342521523 0.706645602708968 -1.539085899664172e-07 -0.09973952297141112 -2.1862000000000004 0.7066468728707422 0.706645743668203 -1.523355814495725e-07 -0.09973960199645784 -2.1863 0.7066470114641445 0.7066458845678611 -1.5073786683444945e-07 -0.09973968099756077 -2.1864 0.7066471500326323 0.7066460254076945 -1.4911582180143768e-07 -0.0997397599747271 -2.1865 0.7066472885764747 0.7066461661874599 -1.474698275039793e-07 -0.09973983892796405 -2.1866 0.7066474270959374 0.7066463069069171 -1.4580027051132316e-07 -0.09973991785727886 -2.1867 0.7066475655912812 0.7066464475658316 -1.441075426922983e-07 -0.0997399967626788 -2.1868000000000003 0.7066477040627623 0.7066465881639717 -1.4239204115980286e-07 -0.09974007564417106 -2.1869 0.7066478425106334 0.706646728701111 -1.4065416813376086e-07 -0.09974015450176282 -2.187 0.7066479809351424 0.706646869177027 -1.388943308786722e-07 -0.09974023333546139 -2.1871 0.7066481193365328 0.7066470095915021 -1.371129416029987e-07 -0.09974031214527397 -2.1872000000000003 0.7066482577150439 0.7066471499443223 -1.3531041734293758e-07 -0.09974039093120773 -2.1873 0.7066483960709096 0.7066472902352791 -1.334871798999715e-07 -0.09974046969326993 -2.1874000000000002 0.7066485344043602 0.7066474304641681 -1.3164365570209058e-07 -0.09974054843146775 -2.1875 0.7066486727156207 0.7066475706307898 -1.2978027574481188e-07 -0.09974062714580845 -2.1875999999999998 0.7066488110049118 0.7066477107349489 -1.2789747544719732e-07 -0.0997407058362992 -2.1877000000000004 0.7066489492724495 0.7066478507764553 -1.2599569459287308e-07 -0.09974078450294725 -2.1878 0.7066490875184446 0.7066479907551235 -1.2407537719472117e-07 -0.09974086314575975 -2.1879 0.7066492257431034 0.7066481306707728 -1.22136971409878e-07 -0.09974094176474395 -2.188 0.706649363946627 0.7066482705232273 -1.2018092943044678e-07 -0.09974102035990699 -2.1881 0.7066495021292121 0.7066484103123161 -1.1820770736727104e-07 -0.09974109893125611 -2.1882 0.7066496402910505 0.7066485500378732 -1.1621776517013738e-07 -0.09974117747879856 -2.1883000000000004 0.7066497784323282 0.7066486896997373 -1.142115664855281e-07 -0.09974125600254141 -2.1884 0.706649916553227 0.7066488292977529 -1.1218957858202816e-07 -0.09974133450249194 -2.1885 0.706650054653923 0.7066489688317686 -1.101522722098125e-07 -0.09974141297865731 -2.1886 0.706650192734588 0.706649108301639 -1.0810012152431825e-07 -0.09974149143104472 -2.1887000000000003 0.706650330795388 0.706649247707223 -1.0603360395006894e-07 -0.09974156985966137 -2.1888 0.7066504688364839 0.7066493870483852 -1.0395320008179526e-07 -0.0997416482645144 -2.1889000000000003 0.7066506068580316 0.7066495263249953 -1.0185939356473911e-07 -0.09974172664561105 -2.189 0.7066507448601818 0.7066496655369281 -9.975267099664176e-08 -0.09974180500295848 -2.1891 0.7066508828430796 0.7066498046840636 -9.763352179937429e-08 -0.09974188333656382 -2.1892000000000005 0.7066510208068653 0.7066499437662872 -9.550243810965003e-08 -0.0997419616464343 -2.1893000000000002 0.7066511587516736 0.7066500827834898 -9.335991467320642e-08 -0.0997420399325771 -2.1894 0.7066512966776335 0.7066502217355674 -9.120644871643546e-08 -0.09974211819499933 -2.1895 0.7066514345848696 0.7066503606224213 -8.904253984316768e-08 -0.0997421964337082 -2.1896 0.7066515724734999 0.7066504994439584 -8.686868990456786e-08 -0.09974227464871088 -2.1897 0.7066517103436379 0.7066506382000908 -8.46854029011232e-08 -0.09974235284001454 -2.1898 0.7066518481953914 0.7066507768907363 -8.249318485340634e-08 -0.09974243100762632 -2.1899 0.7066519860288623 0.7066509155158178 -8.029254368931843e-08 -0.09974250915155336 -2.19 0.706652123844148 0.7066510540752641 -7.808398912092368e-08 -0.0997425872718029 -2.1900999999999997 0.7066522616413394 0.7066511925690091 -7.586803253516183e-08 -0.09974266536838201 -2.1902000000000004 0.7066523994205225 0.7066513309969924 -7.364518686677965e-08 -0.0997427434412979 -2.1903 0.7066525371817771 0.7066514693591589 -7.141596648860965e-08 -0.09974282149055763 -2.1904 0.7066526749251787 0.7066516076554595 -6.918088708146586e-08 -0.09974289951616849 -2.1905 0.7066528126507958 0.7066517458858506 -6.69404655252899e-08 -0.09974297751813757 -2.1906 0.7066529503586925 0.7066518840502931 -6.469521977772036e-08 -0.09974305549647197 -2.1907 0.7066530880489266 0.7066520221487551 -6.244566874528956e-08 -0.0997431334511789 -2.1908000000000003 0.7066532257215503 0.7066521601812091 -6.01923321763044e-08 -0.09974321138226541 -2.1909 0.7066533633766108 0.7066522981476338 -5.7935730533127325e-08 -0.09974328928973873 -2.191 0.7066535010141488 0.7066524360480128 -5.5676384874215126e-08 -0.09974336717360589 -2.1911 0.7066536386342006 0.7066525738823359 -5.341481673051991e-08 -0.09974344503387415 -2.1912000000000003 0.7066537762367961 0.7066527116505986 -5.115154799381627e-08 -0.09974352287055058 -2.1913 0.7066539138219596 0.7066528493528016 -4.8887100787139114e-08 -0.09974360068364228 -2.1914000000000002 0.7066540513897102 0.7066529869889513 -4.662199734649722e-08 -0.09974367847315645 -2.1915 0.7066541889400604 0.7066531245590599 -4.4356759904104655e-08 -0.09974375623910019 -2.1915999999999998 0.7066543264730183 0.7066532620631449 -4.2091910566367384e-08 -0.09974383398148057 -2.1917000000000004 0.7066544639885858 0.7066533995012294 -3.982797119108381e-08 -0.09974391170030472 -2.1918 0.7066546014867593 0.7066535368733426 -3.7565463270540674e-08 -0.09974398939557984 -2.1919 0.7066547389675296 0.7066536741795189 -3.5304907807995334e-08 -0.09974406706731297 -2.192 0.706654876430882 0.7066538114197981 -3.3046825202113356e-08 -0.0997441447155113 -2.1921 0.706655013876796 0.706653948594226 -3.079173512454854e-08 -0.09974422234018188 -2.1922 0.7066551513052457 0.7066540857028534 -2.8540156398349642e-08 -0.0997442999413318 -2.1923000000000004 0.7066552887161996 0.7066542227457373 -2.629260688574546e-08 -0.09974437751896822 -2.1924 0.7066554261096204 0.7066543597229402 -2.40496033582574e-08 -0.09974445507309826 -2.1925 0.7066555634854658 0.7066544966345296 -2.1811661389363468e-08 -0.099744532603729 -2.1926 0.7066557008436875 0.7066546334805786 -1.957929522764662e-08 -0.0997446101108675 -2.1927000000000003 0.7066558381842319 0.7066547702611663 -1.735301768468825e-08 -0.09974468759452092 -2.1928 0.70665597550704 0.706654906976377 -1.51333400112523e-08 -0.09974476505469634 -2.1929000000000003 0.7066561128120469 0.7066550436263003 -1.2920771782793522e-08 -0.09974484249140084 -2.193 0.7066562500991826 0.7066551802110315 -1.07158207853994e-08 -0.09974491990464152 -2.1931 0.7066563873683722 0.7066553167306712 -8.518992895660549e-09 -0.09974499729442551 -2.1932000000000005 0.7066565246195342 0.7066554531853253 -6.330791967046334e-09 -0.09974507466075984 -2.1933000000000002 0.7066566618525826 0.7066555895751052 -4.151719709341584e-09 -0.09974515200365165 -2.1934 0.7066567990674256 0.7066557259001279 -1.98227557892533e-09 -0.09974522932310802 -2.1935 0.7066569362639663 0.7066558621605152 1.770433339862154e-10 -0.09974530661913598 -2.1936 0.7066570734421023 0.7066559983563947 2.3257424293723905e-09 -0.09974538389174263 -2.1937 0.7066572106017261 0.7066561344878989 4.463329697154683e-09 -0.09974546114093508 -2.1938 0.706657347742725 0.7066562705551656 6.589315835157927e-09 -0.09974553836672036 -2.1939 0.7066574848649808 0.7066564065583383 8.703214369673584e-09 -0.09974561556910559 -2.194 0.7066576219683705 0.7066565424975649 1.0804541756073704e-08 -0.09974569274809782 -2.1940999999999997 0.7066577590527652 0.7066566783729991 1.28928174950374e-08 -0.0997457699037041 -2.1942000000000004 0.7066578961180321 0.7066568141847995 1.496756423316481e-08 -0.09974584703593158 -2.1943 0.7066580331640322 0.7066569499331296 1.702830788267301e-08 -0.09974592414478727 -2.1944 0.7066581701906218 0.7066570856181578 1.9074577728948883e-08 -0.09974600123027816 -2.1945 0.7066583071976522 0.7066572212400584 2.1105906529428342e-08 -0.0997460782924114 -2.1946 0.7066584441849699 0.7066573567990099 2.3121830630690177e-08 -0.09974615533119408 -2.1947 0.7066585811524164 0.7066574922951958 2.512189005952903e-08 -0.09974623234663321 -2.1948000000000003 0.7066587180998277 0.7066576277288048 2.7105628653059655e-08 -0.09974630933873581 -2.1949 0.7066588550270362 0.7066577631000298 2.9072594141116292e-08 -0.09974638630750898 -2.195 0.7066589919338686 0.7066578984090692 3.1022338248601344e-08 -0.09974646325295983 -2.1951 0.7066591288201465 0.7066580336561259 3.295441680997713e-08 -0.09974654017509527 -2.1952000000000003 0.7066592656856878 0.7066581688414073 3.4868389864675664e-08 -0.09974661707392245 -2.1953 0.706659402530305 0.706658303965126 3.676382175944737e-08 -0.09974669394944836 -2.1954000000000002 0.706659539353806 0.7066584390274985 3.864028124550556e-08 -0.09974677080168005 -2.1955 0.7066596761559946 0.7066585740287467 4.049734156873208e-08 -0.09974684763062461 -2.1955999999999998 0.7066598129366696 0.7066587089690961 4.233458058416906e-08 -0.09974692443628903 -2.1957000000000004 0.7066599496956254 0.7066588438487775 4.415158083408144e-08 -0.09974700121868035 -2.1958 0.7066600864326522 0.7066589786680259 4.594792966071404e-08 -0.09974707797780559 -2.1959 0.7066602231475356 0.7066591134270801 4.7723219277415185e-08 -0.09974715471367182 -2.196 0.7066603598400572 0.706659248126184 4.947704689006738e-08 -0.09974723142628605 -2.1961 0.7066604965099939 0.706659382765585 5.1209014752598425e-08 -0.09974730811565531 -2.1962 0.7066606331571186 0.7066595173455357 5.291873029882044e-08 -0.09974738478178669 -2.1963000000000004 0.7066607697812001 0.7066596518662919 5.460580618579791e-08 -0.0997474614246871 -2.1964 0.7066609063820031 0.7066597863281139 5.626986042915616e-08 -0.09974753804436363 -2.1965 0.7066610429592879 0.7066599207312658 5.791051644991885e-08 -0.09974761464082327 -2.1966 0.7066611795128115 0.706660055076016 5.95274031785914e-08 -0.09974769121407304 -2.1967000000000003 0.7066613160423265 0.7066601893626367 6.112015512454994e-08 -0.09974776776411998 -2.1968 0.7066614525475816 0.7066603235914042 6.268841249747192e-08 -0.09974784429097112 -2.1969000000000003 0.706661589028322 0.7066604577625977 6.423182124029592e-08 -0.09974792079463342 -2.197 0.7066617254842888 0.706660591876501 6.575003313157024e-08 -0.0997479972751139 -2.1971 0.7066618619152201 0.7066607259334013 6.724270585831138e-08 -0.09974807373241956 -2.1972000000000005 0.7066619983208495 0.7066608599335893 6.870950311141377e-08 -0.09974815016655744 -2.1973000000000003 0.7066621347009078 0.7066609938773596 7.015009463248734e-08 -0.09974822657753452 -2.1974 0.7066622710551216 0.7066611277650099 7.156415630753254e-08 -0.0997483029653578 -2.1975 0.7066624073832151 0.706661261596841 7.295137023459464e-08 -0.09974837933003429 -2.1976 0.7066625436849083 0.7066613953731576 7.431142480009145e-08 -0.09974845567157098 -2.1977 0.7066626799599183 0.7066615290942677 7.564401473432458e-08 -0.09974853198997485 -2.1978 0.7066628162079587 0.7066616627604818 7.69488411947461e-08 -0.0997486082852529 -2.1979 0.7066629524287403 0.7066617963721145 7.822561183014332e-08 -0.09974868455741209 -2.198 0.7066630886219709 0.7066619299294826 7.94740408326805e-08 -0.09974876080645949 -2.1980999999999997 0.706663224787355 0.7066620634329064 8.069384902290033e-08 -0.099748837032402 -2.1982000000000004 0.7066633609245943 0.7066621968827089 8.188476389482668e-08 -0.09974891323524665 -2.1983 0.7066634970333875 0.7066623302792159 8.304651969749666e-08 -0.09974898941500038 -2.1984 0.7066636331134311 0.7066624636227561 8.417885745924669e-08 -0.09974906557167025 -2.1985 0.7066637691644182 0.7066625969136611 8.528152508832654e-08 -0.0997491417052632 -2.1986 0.7066639051860396 0.7066627301522643 8.635427739545065e-08 -0.09974921781578616 -2.1987 0.7066640411779835 0.7066628633389027 8.73968761597177e-08 -0.0997492939032461 -2.1988000000000003 0.706664177139936 0.7066629964739151 8.840909018065224e-08 -0.09974936996765012 -2.1989 0.7066643130715801 0.7066631295576428 8.939069533545063e-08 -0.09974944600900505 -2.199 0.7066644489725967 0.7066632625904294 9.034147462061437e-08 -0.09974952202731792 -2.1991 0.7066645848426647 0.7066633955726211 9.12612182039918e-08 -0.09974959802259564 -2.1992000000000003 0.706664720681461 0.7066635285045655 9.214972346294203e-08 -0.09974967399484524 -2.1993 0.70666485648866 0.7066636613866131 9.300679504331555e-08 -0.09974974994407365 -2.1994000000000002 0.7066649922639339 0.7066637942191158 9.383224490108755e-08 -0.09974982587028781 -2.1995 0.7066651280069534 0.7066639270024281 9.462589230929686e-08 -0.0997499017734947 -2.1995999999999998 0.7066652637173878 0.7066640597369053 9.538756396212933e-08 -0.09974997765370128 -2.1997000000000004 0.7066653993949031 0.7066641924229056 9.611709394022339e-08 -0.09975005351091448 -2.1998 0.7066655350391653 0.7066643250607885 9.681432381128396e-08 -0.0997501293451413 -2.1999 0.7066656706498378 0.7066644576509142 9.747910261967418e-08 -0.0997502051563886 -2.2 0.7066658062265826 0.7066645901936459 9.811128693845705e-08 -0.0997502809446634 -2.2001 0.7066659417690606 0.7066647226893474 9.87107408867427e-08 -0.09975035670997262 -2.2002 0.7066660772769309 0.7066648551383838 9.927733618866896e-08 -0.0997504324523232 -2.2003000000000004 0.7066662127498516 0.7066649875411217 9.981095215952362e-08 -0.09975050817172205 -2.2004 0.7066663481874795 0.7066651198979292 1.0031147576819444e-07 -0.09975058386817616 -2.2005 0.7066664835894705 0.7066652522091748 1.0077880163369968e-07 -0.09975065954169243 -2.2006 0.7066666189554789 0.7066653844752286 1.0121283205641318e-07 -0.09975073519227781 -2.2007000000000003 0.7066667542851586 0.7066655166964614 1.0161347704235046e-07 -0.09975081081993921 -2.2008 0.7066668895781625 0.7066656488732451 1.019806543239854e-07 -0.09975088642468362 -2.2009000000000003 0.7066670248341423 0.7066657810059521 1.023142893810669e-07 -0.0997509620065179 -2.201 0.7066671600527497 0.7066659130949557 1.0261431541633281e-07 -0.099751037565449 -2.2011 0.706667295233635 0.7066660451406297 1.0288067343530716e-07 -0.09975111310148384 -2.2012000000000005 0.7066674303764487 0.7066661771433487 1.0311331218731956e-07 -0.09975118861462934 -2.2013000000000003 0.7066675654808403 0.706666309103487 1.0331218823836363e-07 -0.0997512641048924 -2.2014 0.7066677005464592 0.7066664410214201 1.034772659364025e-07 -0.09975133957227997 -2.2015 0.7066678355729545 0.7066665728975239 1.0360851740096044e-07 -0.09975141501679902 -2.2016 0.706667970559975 0.7066667047321734 1.0370592261679801e-07 -0.09975149043845634 -2.2017 0.7066681055071691 0.7066668365257446 1.0376946931942022e-07 -0.09975156583725889 -2.2018 0.7066682404141857 0.7066669682786133 1.037991530852822e-07 -0.09975164121321355 -2.2019 0.7066683752806736 0.7066670999911555 1.0379497727974751e-07 -0.09975171656632731 -2.202 0.7066685101062816 0.7066672316637466 1.0375695309525201e-07 -0.09975179189660699 -2.2020999999999997 0.7066686448906587 0.7066673632967622 1.0368509948885385e-07 -0.09975186720405954 -2.2022000000000004 0.7066687796334543 0.7066674948905771 1.0357944322039736e-07 -0.09975194248869185 -2.2023 0.7066689143343179 0.7066676264455662 1.0344001885251308e-07 -0.0997520177505108 -2.2024 0.7066690489929 0.7066677579621039 1.0326686867775936e-07 -0.09975209298952331 -2.2025 0.7066691836088513 0.7066678894405638 1.0306004279841963e-07 -0.09975216820573628 -2.2026 0.7066693181818229 0.7066680208813189 1.0281959902588844e-07 -0.09975224339915656 -2.2027 0.7066694527114672 0.7066681522847416 1.025456029327132e-07 -0.0997523185697911 -2.2028000000000003 0.7066695871974369 0.7066682836512033 1.0223812775891905e-07 -0.09975239371764671 -2.2029 0.7066697216393858 0.7066684149810749 1.018972544987451e-07 -0.09975246884273037 -2.203 0.7066698560369686 0.7066685462747258 1.0152307178268316e-07 -0.09975254394504886 -2.2031 0.7066699903898412 0.7066686775325248 1.0111567588788617e-07 -0.09975261902460916 -2.2032000000000003 0.7066701246976601 0.7066688087548394 1.0067517073816812e-07 -0.09975269408141806 -2.2033 0.7066702589600837 0.7066689399420358 1.0020166782073736e-07 -0.0997527691154825 -2.2034000000000002 0.7066703931767714 0.7066690710944792 9.969528624864665e-08 -0.09975284412680933 -2.2035 0.7066705273473839 0.7066692022125329 9.915615263589306e-08 -0.09975291911540543 -2.2036 0.7066706614715832 0.7066693332965592 9.858440112517353e-08 -0.09975299408127766 -2.2037000000000004 0.7066707955490332 0.7066694643469189 9.79801733219654e-08 -0.09975306902443289 -2.2038 0.7066709295793991 0.7066695953639708 9.734361828758753e-08 -0.09975314394487801 -2.2039 0.7066710635623482 0.7066697263480721 9.667489248021965e-08 -0.09975321884261987 -2.204 0.706671197497549 0.7066698572995787 9.597415972714685e-08 -0.09975329371766531 -2.2041 0.7066713313846724 0.7066699882188441 9.524159120047337e-08 -0.09975336857002125 -2.2042 0.7066714652233907 0.7066701191062199 9.447736532344764e-08 -0.09975344339969447 -2.2043000000000004 0.7066715990133785 0.7066702499620559 9.368166779821774e-08 -0.09975351820669186 -2.2044 0.7066717327543125 0.7066703807866999 9.285469150174808e-08 -0.09975359299102028 -2.2045 0.7066718664458715 0.7066705115804972 9.199663646153322e-08 -0.0997536677526866 -2.2046 0.7066720000877367 0.7066706423437914 9.110770983478123e-08 -0.09975374249169768 -2.2047000000000003 0.7066721336795914 0.7066707730769233 9.018812578698299e-08 -0.09975381720806036 -2.2048 0.706672267221121 0.7066709037802312 8.923810553007616e-08 -0.09975389190178147 -2.2049000000000003 0.7066724007120139 0.7066710344540514 8.825787718713674e-08 -0.09975396657286784 -2.205 0.7066725341519606 0.7066711650987175 8.724767580278736e-08 -0.0997540412213263 -2.2051 0.7066726675406547 0.7066712957145602 8.620774324605285e-08 -0.09975411584716375 -2.2052000000000005 0.7066728008777919 0.7066714263019078 8.513832815137956e-08 -0.09975419045038697 -2.2053000000000003 0.7066729341630713 0.7066715568610861 8.403968591343125e-08 -0.09975426503100282 -2.2054 0.7066730673961941 0.7066716873924175 8.291207854137228e-08 -0.09975433958901815 -2.2055 0.7066732005768647 0.7066718178962217 8.175577466927597e-08 -0.09975441412443972 -2.2056 0.706673333704791 0.7066719483728157 8.057104945898008e-08 -0.0997544886372745 -2.2057 0.7066734667796832 0.7066720788225129 7.935818453763677e-08 -0.09975456312752921 -2.2058 0.7066735998012548 0.7066722092456243 7.811746793526253e-08 -0.09975463759521068 -2.2059 0.7066737327692221 0.7066723396424577 7.684919400494095e-08 -0.09975471204032577 -2.206 0.7066738656833056 0.7066724700133168 7.555366337771985e-08 -0.09975478646288127 -2.2060999999999997 0.7066739985432283 0.7066726003585027 7.423118286373209e-08 -0.09975486086288403 -2.2062000000000004 0.706674131348717 0.7066727306783127 7.288206539321496e-08 -0.09975493524034085 -2.2063 0.7066742640995016 0.7066728609730413 7.150662995232537e-08 -0.09975500959525854 -2.2064 0.7066743967953157 0.706672991242979 7.010520148773014e-08 -0.09975508392764394 -2.2065 0.7066745294358964 0.7066731214884128 6.867811084415587e-08 -0.09975515823750385 -2.2066 0.7066746620209842 0.7066732517096259 6.722569466204031e-08 -0.09975523252484503 -2.2067 0.7066747945503237 0.7066733819068984 6.574829534804205e-08 -0.09975530678967436 -2.2068000000000003 0.706674927023663 0.7066735120805061 6.424626095360986e-08 -0.09975538103199859 -2.2069 0.706675059440754 0.7066736422307212 6.271994508304235e-08 -0.09975545525182453 -2.207 0.7066751918013526 0.706673772357812 6.116970685879353e-08 -0.09975552944915904 -2.2071 0.7066753241052184 0.706673902462043 5.9595910784429607e-08 -0.09975560362400887 -2.2072000000000003 0.706675456352115 0.7066740325436744 5.799892670993456e-08 -0.09975567777638081 -2.2073 0.7066755885418103 0.7066741626029627 5.637912969293224e-08 -0.09975575190628165 -2.2074000000000003 0.7066757206740761 0.7066742926401599 5.473689994837938e-08 -0.09975582601371819 -2.2075 0.7066758527486885 0.7066744226555144 5.307262274448221e-08 -0.09975590009869727 -2.2076 0.7066759847654274 0.7066745526492701 5.138668831422555e-08 -0.09975597416122564 -2.2077000000000004 0.7066761167240773 0.7066746826216667 4.967949177384079e-08 -0.09975604820131008 -2.2078 0.7066762486244269 0.7066748125729392 4.795143300657945e-08 -0.09975612221895738 -2.2079 0.706676380466269 0.706674942503319 4.620291658985476e-08 -0.09975619621417432 -2.208 0.7066765122494014 0.7066750724130326 4.44343516998319e-08 -0.0997562701869677 -2.2081 0.7066766439736261 0.7066752023023022 4.2646151998670945e-08 -0.09975634413734434 -2.2082 0.706676775638749 0.7066753321713453 4.083873555993378e-08 -0.09975641806531092 -2.2083000000000004 0.7066769072445811 0.7066754620203746 3.901252475062289e-08 -0.09975649197087422 -2.2084 0.7066770387909381 0.7066755918495992 3.716794615138408e-08 -0.09975656585404104 -2.2085 0.7066771702776402 0.7066757216592228 3.530543044374945e-08 -0.09975663971481823 -2.2086 0.7066773017045123 0.7066758514494447 3.342541230952345e-08 -0.09975671355321246 -2.2087000000000003 0.7066774330713834 0.7066759812204593 3.15283303457814e-08 -0.09975678736923055 -2.2088 0.706677564378088 0.7066761109724561 2.961462693823469e-08 -0.09975686116287923 -2.2089000000000003 0.7066776956244654 0.7066762407056201 2.7684748174494622e-08 -0.09975693493416524 -2.209 0.706677826810359 0.7066763704201316 2.5739143738254255e-08 -0.0997570086830954 -2.2091 0.7066779579356179 0.7066765001161657 2.3778266791327218e-08 -0.09975708240967641 -2.2092 0.7066780890000958 0.7066766297938927 2.1802573895585153e-08 -0.09975715611391511 -2.2093000000000003 0.7066782200036508 0.706676759453478 1.981252488458818e-08 -0.09975722979581815 -2.2094 0.7066783509461471 0.7066768890950816 1.780858275429731e-08 -0.09975730345539235 -2.2095 0.7066784818274527 0.7066770187188591 1.5791213567664664e-08 -0.09975737709264443 -2.2096 0.7066786126474417 0.706677148324961 1.3760886347947976e-08 -0.09975745070758113 -2.2097 0.7066787434059925 0.7066772779135324 1.1718072952075775e-08 -0.09975752430020923 -2.2098 0.706678874102989 0.7066774074847133 9.663247987380663e-09 -0.0997575978705355 -2.2099 0.7066790047383198 0.7066775370386389 7.59688867108671e-09 -0.09975767141856658 -2.21 0.7066791353118793 0.7066776665754388 5.519474743573283e-09 -0.09975774494430929 -2.2100999999999997 0.7066792658235667 0.7066777960952378 3.431488353883294e-09 -0.09975781844777036 -2.2102000000000004 0.7066793962732862 0.7066779255981555 1.3334139278842194e-09 -0.09975789192895651 -2.2103 0.7066795266609478 0.7066780550843057 -7.742619167333542e-10 -0.09975796538787449 -2.2104 0.7066796569864662 0.7066781845537978 -2.89105050142735e-09 -0.09975803882453105 -2.2105 0.7066797872497612 0.7066783140067354 -5.016461191754973e-09 -0.09975811223893283 -2.2106 0.706679917450759 0.7066784434432167 -7.150001517068627e-09 -0.09975818563108668 -2.2107 0.7066800475893897 0.7066785728633349 -9.291177282405583e-09 -0.09975825900099926 -2.2108000000000003 0.7066801776655898 0.7066787022671779 -1.1439492674306107e-08 -0.0997583323486773 -2.2109 0.7066803076793005 0.7066788316548275 -1.359445038961668e-08 -0.09975840567412747 -2.211 0.7066804376304683 0.7066789610263614 -1.575555174477758e-08 -0.09975847897735654 -2.2111 0.706680567519046 0.7066790903818511 -1.7922296785977815e-08 -0.09975855225837127 -2.2112000000000003 0.7066806973449907 0.7066792197213627 -2.0094184414055222e-08 -0.09975862551717832 -2.2113 0.7066808271082655 0.7066793490449574 -2.2270712491181954e-08 -0.09975869875378446 -2.2114000000000003 0.7066809568088386 0.7066794783526905 -2.4451377964029852e-08 -0.09975877196819632 -2.2115 0.7066810864466837 0.7066796076446118 -2.6635676976093786e-08 -0.09975884516042065 -2.2116 0.7066812160217798 0.7066797369207665 -2.8823104985869694e-08 -0.09975891833046417 -2.2117000000000004 0.7066813455341115 0.7066798661811933 -3.101315688221369e-08 -0.09975899147833354 -2.2118 0.7066814749836691 0.7066799954259264 -3.320532710382115e-08 -0.09975906460403552 -2.2119 0.7066816043704476 0.7066801246549941 -3.539910974873113e-08 -0.09975913770757681 -2.212 0.706681733694448 0.7066802538684192 -3.7593998700093806e-08 -0.0997592107889641 -2.2121 0.7066818629556764 0.7066803830662189 -3.978948773632543e-08 -0.09975928384820403 -2.2122 0.7066819921541445 0.7066805122484057 -4.198507065069582e-08 -0.09975935688530332 -2.2123000000000004 0.7066821212898698 0.706680641414986 -4.418024136743288e-08 -0.09975942990026873 -2.2124 0.7066822503628746 0.706680770565961 -4.637449405877573e-08 -0.0997595028931069 -2.2125 0.7066823793731868 0.7066808997013263 -4.856732325943941e-08 -0.0997595758638245 -2.2126 0.7066825083208398 0.7066810288210723 -5.0758223986229443e-08 -0.09975964881242826 -2.2127000000000003 0.7066826372058725 0.7066811579251839 -5.294669185203216e-08 -0.09975972173892483 -2.2128 0.7066827660283289 0.7066812870136405 -5.5132223182163126e-08 -0.09975979464332088 -2.2129000000000003 0.706682894788259 0.7066814160864164 -5.731431512961786e-08 -0.09975986752562316 -2.213 0.7066830234857177 0.7066815451434801 -5.949246579444248e-08 -0.09975994038583834 -2.2131 0.706683152120765 0.7066816741847952 -6.166617433443072e-08 -0.09976001322397307 -2.2132 0.7066832806934669 0.7066818032103193 -6.383494108221782e-08 -0.099760086040034 -2.2133000000000003 0.7066834092038944 0.7066819322200049 -6.599826766172379e-08 -0.09976015883402783 -2.2134 0.706683537652124 0.7066820612137998 -6.815565709722415e-08 -0.0997602316059613 -2.2135 0.7066836660382372 0.7066821901916454 -7.030661393521431e-08 -0.09976030435584095 -2.2136 0.706683794362321 0.7066823191534785 -7.245064435196236e-08 -0.0997603770836735 -2.2137000000000002 0.7066839226244678 0.7066824480992302 -7.458725626756715e-08 -0.09976044978946562 -2.2138 0.7066840508247751 0.7066825770288271 -7.671595946608795e-08 -0.09976052247322398 -2.2139 0.7066841789633456 0.7066827059421896 -7.883626569615831e-08 -0.09976059513495522 -2.214 0.7066843070402875 0.7066828348392337 -8.094768878981473e-08 -0.09976066777466604 -2.2140999999999997 0.7066844350557137 0.7066829637198696 -8.304974477481991e-08 -0.09976074039236309 -2.2142000000000004 0.7066845630097427 0.7066830925840024 -8.514195198525143e-08 -0.09976081298805299 -2.2143 0.7066846909024977 0.7066832214315324 -8.722383116471777e-08 -0.09976088556174238 -2.2144 0.7066848187341079 0.7066833502623546 -8.929490558952369e-08 -0.09976095811343799 -2.2145 0.7066849465047065 0.7066834790763589 -9.135470116147792e-08 -0.0997610306431464 -2.2146 0.7066850742144323 0.7066836078734301 -9.34027465301912e-08 -0.0997611031508743 -2.2147 0.7066852018634289 0.7066837366534481 -9.543857320149646e-08 -0.09976117563662831 -2.2148000000000003 0.7066853294518453 0.7066838654162876 -9.746171562418499e-08 -0.09976124810041509 -2.2149 0.706685456979835 0.7066839941618184 -9.94717113209781e-08 -0.09976132054224127 -2.215 0.7066855844475566 0.7066841228899056 -1.0146810098480424e-07 -0.09976139296211348 -2.2151 0.7066857118551736 0.706684251600409 -1.0345042857160675e-07 -0.09976146536003838 -2.2152000000000003 0.7066858392028544 0.706684380293184 -1.0541824143391748e-07 -0.09976153773602256 -2.2153 0.7066859664907722 0.7066845089680809 -1.0737109039371528e-07 -0.09976161009007271 -2.2154000000000003 0.7066860937191051 0.7066846376249452 -1.0930852985605033e-07 -0.09976168242219544 -2.2155 0.7066862208880353 0.7066847662636173 -1.1123011792180115e-07 -0.09976175473239735 -2.2156 0.7066863479977505 0.706684894883934 -1.1313541647094139e-07 -0.09976182702068509 -2.2157000000000004 0.7066864750484427 0.7066850234857267 -1.1502399126922525e-07 -0.09976189928706532 -2.2158 0.7066866020403086 0.7066851520688219 -1.1689541207400567e-07 -0.09976197153154463 -2.2159 0.7066867289735493 0.7066852806330419 -1.187492527227052e-07 -0.09976204375412964 -2.216 0.7066868558483704 0.7066854091782048 -1.2058509122996053e-07 -0.09976211595482698 -2.2161 0.7066869826649823 0.7066855377041233 -1.224025098934406e-07 -0.09976218813364324 -2.2162 0.7066871094235994 0.7066856662106068 -1.2420109537711332e-07 -0.09976226029058505 -2.2163000000000004 0.706687236124441 0.7066857946974594 -1.2598043881012488e-07 -0.09976233242565906 -2.2164 0.70668736276773 0.7066859231644813 -1.2774013589088307e-07 -0.09976240453887185 -2.2165 0.7066874893536945 0.7066860516114684 -1.2947978695471152e-07 -0.09976247663023004 -2.2166 0.7066876158825659 0.7066861800382122 -1.3119899707619842e-07 -0.09976254869974022 -2.2167000000000003 0.7066877423545803 0.7066863084445 -1.3289737617154518e-07 -0.09976262074740898 -2.2168 0.7066878687699779 0.7066864368301151 -1.3457453907662897e-07 -0.09976269277324294 -2.2169 0.706687995129003 0.7066865651948369 -1.3623010561292226e-07 -0.09976276477724874 -2.217 0.7066881214319038 0.7066866935384405 -1.3786370071759702e-07 -0.09976283675943294 -2.2171 0.7066882476789323 0.706686821860697 -1.3947495450250535e-07 -0.09976290871980216 -2.2172 0.7066883738703447 0.7066869501613737 -1.4106350232530318e-07 -0.09976298065836298 -2.2173000000000003 0.7066885000064009 0.706687078440234 -1.4262898489700304e-07 -0.09976305257512197 -2.2174 0.7066886260873646 0.7066872066970377 -1.4417104836177141e-07 -0.09976312447008573 -2.2175 0.7066887521135035 0.7066873349315406 -1.4568934433856207e-07 -0.0997631963432609 -2.2176 0.7066888780850882 0.706687463143495 -1.4718353006162865e-07 -0.09976326819465403 -2.2177000000000002 0.7066890040023938 0.7066875913326496 -1.486532684221581e-07 -0.09976334002427172 -2.2178 0.7066891298656985 0.7066877194987493 -1.5009822802725115e-07 -0.09976341183212055 -2.2179 0.706689255675284 0.7066878476415357 -1.5151808331267946e-07 -0.09976348361820708 -2.218 0.7066893814314354 0.7066879757607469 -1.5291251459319255e-07 -0.09976355538253791 -2.2180999999999997 0.7066895071344412 0.7066881038561179 -1.54281208130172e-07 -0.0997636271251196 -2.2182000000000004 0.7066896327845935 0.7066882319273802 -1.5562385623051067e-07 -0.09976369884595876 -2.2183 0.706689758382187 0.7066883599742617 -1.5694015729518507e-07 -0.09976377054506193 -2.2184 0.70668988392752 0.706688487996488 -1.5822981586782747e-07 -0.09976384222243569 -2.2185 0.7066900094208939 0.7066886159937806 -1.5949254274748303e-07 -0.09976391387808661 -2.2186 0.7066901348626127 0.7066887439658589 -1.6072805501636533e-07 -0.09976398551202127 -2.2187 0.7066902602529839 0.7066888719124387 -1.619360761005717e-07 -0.09976405712424623 -2.2188000000000003 0.7066903855923177 0.7066889998332331 -1.6311633587069718e-07 -0.09976412871476803 -2.2189 0.706690510880927 0.7066891277279524 -1.642685706695901e-07 -0.09976420028359329 -2.219 0.7066906361191274 0.7066892555963042 -1.653925233713327e-07 -0.0997642718307285 -2.2191 0.7066907613072374 0.706689383437993 -1.6648794344889528e-07 -0.09976434335618023 -2.2192000000000003 0.7066908864455779 0.7066895112527216 -1.6755458704352522e-07 -0.09976441485995508 -2.2193 0.7066910115344727 0.7066896390401893 -1.6859221697515525e-07 -0.09976448634205955 -2.2194000000000003 0.7066911365742474 0.7066897668000937 -1.6960060283434386e-07 -0.09976455780250025 -2.2195 0.7066912615652305 0.7066898945321294 -1.7057952103258223e-07 -0.09976462924128371 -2.2196 0.7066913865077527 0.7066900222359889 -1.715287548283151e-07 -0.09976470065841643 -2.2197000000000005 0.7066915114021469 0.7066901499113627 -1.7244809439112552e-07 -0.09976477205390503 -2.2198 0.7066916362487484 0.7066902775579386 -1.73337336845103e-07 -0.09976484342775603 -2.2199 0.7066917610478941 0.7066904051754027 -1.7419628631568096e-07 -0.09976491477997596 -2.22 0.7066918857999233 0.7066905327634392 -1.7502475395045347e-07 -0.09976498611057133 -2.2201 0.7066920105051768 0.70669066032173 -1.7582255800938085e-07 -0.09976505741954872 -2.2202 0.7066921351639983 0.7066907878499554 -1.7658952385091187e-07 -0.09976512870691473 -2.2203000000000004 0.706692259776732 0.7066909153477938 -1.7732548400484216e-07 -0.09976519997267579 -2.2204 0.7066923843437245 0.7066910428149216 -1.7803027821047812e-07 -0.09976527121683844 -2.2205 0.7066925088653238 0.7066911702510139 -1.7870375340969802e-07 -0.09976534243940922 -2.2206 0.7066926333418797 0.7066912976557446 -1.7934576383368817e-07 -0.09976541364039473 -2.2207000000000003 0.7066927577737432 0.7066914250287855 -1.7995617098906513e-07 -0.09976548481980141 -2.2208 0.706692882161267 0.7066915523698067 -1.8053484373767303e-07 -0.09976555597763584 -2.2209 0.7066930065048047 0.7066916796784782 -1.8108165826188904e-07 -0.09976562711390448 -2.221 0.7066931308047113 0.7066918069544676 -1.815964981444207e-07 -0.09976569822861388 -2.2211 0.7066932550613432 0.7066919341974423 -1.8207925438218364e-07 -0.09976576932177057 -2.2212 0.7066933792750576 0.7066920614070675 -1.825298253793628e-07 -0.09976584039338106 -2.2213000000000003 0.706693503446213 0.7066921885830084 -1.8294811698210678e-07 -0.09976591144345191 -2.2214 0.7066936275751684 0.7066923157249287 -1.833340425444474e-07 -0.09976598247198958 -2.2215 0.7066937516622838 0.7066924428324919 -1.8368752287972745e-07 -0.09976605347900058 -2.2216 0.7066938757079199 0.7066925699053597 -1.840084862952951e-07 -0.09976612446449144 -2.2217000000000002 0.7066939997124381 0.7066926969431937 -1.8429686862372896e-07 -0.0997661954284686 -2.2218 0.7066941236762008 0.7066928239456551 -1.845526132367159e-07 -0.09976626637093866 -2.2219 0.7066942475995702 0.7066929509124046 -1.8477567104158155e-07 -0.09976633729190805 -2.222 0.7066943714829097 0.706693077843102 -1.8496600047782086e-07 -0.09976640819138334 -2.2220999999999997 0.7066944953265826 0.7066932047374068 -1.8512356756220094e-07 -0.099766479069371 -2.2222000000000004 0.706694619130952 0.7066933315949788 -1.8524834586794436e-07 -0.0997665499258775 -2.2223 0.7066947428963819 0.706693458415477 -1.8534031652472915e-07 -0.09976662076090935 -2.2224 0.7066948666232366 0.7066935851985606 -1.8539946824297493e-07 -0.09976669157447304 -2.2225 0.7066949903118795 0.7066937119438887 -1.8542579729302622e-07 -0.0997667623665751 -2.2226 0.7066951139626751 0.7066938386511206 -1.854193075086219e-07 -0.09976683313722201 -2.2227 0.7066952375759863 0.7066939653199151 -1.8538001029730355e-07 -0.0997669038864202 -2.2228000000000003 0.7066953611521773 0.7066940919499323 -1.8530792461959877e-07 -0.09976697461417625 -2.2229 0.7066954846916109 0.7066942185408311 -1.8520307698208227e-07 -0.09976704532049652 -2.223 0.7066956081946503 0.7066943450922722 -1.8506550144084533e-07 -0.09976711600538757 -2.2231 0.7066957316616573 0.7066944716039161 -1.8489523959108745e-07 -0.09976718666885585 -2.2232000000000003 0.7066958550929943 0.706694598075424 -1.846923405393608e-07 -0.09976725731090785 -2.2233 0.7066959784890221 0.7066947245064578 -1.8445686090010072e-07 -0.09976732793155008 -2.2234000000000003 0.7066961018501015 0.7066948508966797 -1.8418886478521745e-07 -0.09976739853078898 -2.2235 0.706696225176592 0.7066949772457529 -1.838884237902183e-07 -0.09976746910863105 -2.2236 0.7066963484688524 0.7066951035533415 -1.8355561695257427e-07 -0.09976753966508267 -2.2237000000000005 0.7066964717272408 0.7066952298191108 -1.83190530758659e-07 -0.09976761020015043 -2.2238 0.7066965949521139 0.7066953560427265 -1.827932590951764e-07 -0.09976768071384069 -2.2239 0.7066967181438275 0.7066954822238559 -1.823639032456914e-07 -0.09976775120615998 -2.224 0.7066968413027364 0.7066956083621672 -1.8190257185246583e-07 -0.09976782167711475 -2.2241 0.7066969644291936 0.7066957344573299 -1.814093809060502e-07 -0.09976789212671143 -2.2242 0.7066970875235514 0.7066958605090152 -1.808844537140586e-07 -0.09976796255495651 -2.2243000000000004 0.7066972105861602 0.7066959865168954 -1.8032792083871874e-07 -0.09976803296185645 -2.2244 0.706697333617369 0.7066961124806439 -1.7973992010034134e-07 -0.09976810334741769 -2.2245 0.7066974566175251 0.7066962383999364 -1.7912059652527845e-07 -0.09976817371164666 -2.2245999999999997 0.706697579586975 0.7066963642744499 -1.7847010232510674e-07 -0.09976824405454986 -2.2247000000000003 0.7066977025260626 0.7066964901038628 -1.7778859683764692e-07 -0.0997683143761337 -2.2248 0.7066978254351299 0.706696615887856 -1.7707624651308596e-07 -0.09976838467640466 -2.2249 0.7066979483145178 0.7066967416261116 -1.7633322485499647e-07 -0.09976845495536917 -2.225 0.7066980711645645 0.706696867318314 -1.7555971238564227e-07 -0.09976852521303366 -2.2251 0.7066981939856067 0.7066969929641497 -1.7475589659393664e-07 -0.09976859544940458 -2.2252 0.7066983167779785 0.7066971185633069 -1.7392197191115621e-07 -0.09976866566448833 -2.2253000000000003 0.7066984395420122 0.7066972441154764 -1.7305813963808259e-07 -0.09976873585829141 -2.2254 0.7066985622780377 0.706697369620351 -1.7216460791551202e-07 -0.09976880603082022 -2.2255 0.7066986849863827 0.7066974950776261 -1.7124159165833597e-07 -0.0997688761820812 -2.2256 0.7066988076673721 0.7066976204869988 -1.7028931252084656e-07 -0.09976894631208076 -2.2257000000000002 0.7066989303213291 0.7066977458481697 -1.6930799883949077e-07 -0.09976901642082536 -2.2258 0.7066990529485738 0.7066978711608409 -1.6829788555480785e-07 -0.09976908650832145 -2.2259 0.7066991755494236 0.7066979964247178 -1.6725921419928624e-07 -0.09976915657457536 -2.226 0.706699298124194 0.7066981216395081 -1.6619223280368856e-07 -0.09976922661959364 -2.2260999999999997 0.7066994206731965 0.7066982468049223 -1.6509719584847926e-07 -0.09976929664338259 -2.2262000000000004 0.7066995431967409 0.706698371920674 -1.639743641961705e-07 -0.09976936664594874 -2.2263 0.7066996656951333 0.7066984969864792 -1.6282400505142347e-07 -0.09976943662729842 -2.2264 0.7066997881686776 0.7066986220020574 -1.6164639188472052e-07 -0.09976950658743806 -2.2265 0.7066999106176743 0.7066987469671305 -1.6044180435430266e-07 -0.09976957652637414 -2.2266 0.7067000330424207 0.7066988718814239 -1.592105282575973e-07 -0.09976964644411297 -2.2267 0.7067001554432112 0.706698996744666 -1.579528554514209e-07 -0.09976971634066105 -2.2268000000000003 0.7067002778203368 0.7066991215565885 -1.5666908380340683e-07 -0.09976978621602474 -2.2269 0.7067004001740853 0.7066992463169264 -1.5535951708792184e-07 -0.09976985607021045 -2.227 0.7067005225047414 0.7066993710254176 -1.5402446494443278e-07 -0.0997699259032246 -2.2271 0.7067006448125858 0.7066994956818038 -1.526642427977093e-07 -0.09976999571507357 -2.2272000000000003 0.7067007670978964 0.7066996202858302 -1.5127917177976125e-07 -0.09977006550576378 -2.2273 0.7067008893609472 0.7066997448372454 -1.4986957863616368e-07 -0.09977013527530164 -2.2274000000000003 0.7067010116020088 0.7066998693358013 -1.4843579567748455e-07 -0.09977020502369352 -2.2275 0.7067011338213478 0.7066999937812539 -1.4697816069775271e-07 -0.09977027475094578 -2.2276 0.7067012560192276 0.7067001181733625 -1.4549701687731342e-07 -0.09977034445706484 -2.2277000000000005 0.7067013781959077 0.7067002425118909 -1.439927126995616e-07 -0.09977041414205717 -2.2278000000000002 0.7067015003516435 0.7067003667966053 -1.4246560190930846e-07 -0.09977048380592907 -2.2279 0.7067016224866869 0.7067004910272772 -1.409160433930856e-07 -0.09977055344868696 -2.228 0.7067017446012855 0.706700615203681 -1.3934440108546997e-07 -0.0997706230703372 -2.2281 0.7067018666956835 0.706700739325596 -1.3775104392051152e-07 -0.09977069267088622 -2.2282 0.7067019887701202 0.7067008633928042 -1.3613634571897626e-07 -0.09977076225034029 -2.2283000000000004 0.7067021108248319 0.7067009874050931 -1.345006851120184e-07 -0.09977083180870588 -2.2284 0.7067022328600501 0.7067011113622533 -1.3284444544230112e-07 -0.09977090134598937 -2.2285 0.7067023548760019 0.7067012352640804 -1.3116801467899508e-07 -0.09977097086219713 -2.2285999999999997 0.7067024768729109 0.7067013591103732 -1.2947178533451176e-07 -0.09977104035733551 -2.2287000000000003 0.7067025988509958 0.7067014829009357 -1.277561543690936e-07 -0.0997711098314109 -2.2288 0.7067027208104715 0.7067016066355757 -1.260215230902001e-07 -0.09977117928442963 -2.2289 0.706702842751548 0.7067017303141054 -1.242682970588327e-07 -0.09977124871639813 -2.229 0.7067029646744312 0.7067018539363419 -1.2249688601147224e-07 -0.09977131812732268 -2.2291 0.7067030865793225 0.706701977502106 -1.2070770374732198e-07 -0.09977138751720972 -2.2292 0.7067032084664189 0.7067021010112234 -1.1890116803463247e-07 -0.09977145688606559 -2.2293000000000003 0.7067033303359128 0.7067022244635244 -1.1707770051355704e-07 -0.09977152623389667 -2.2294 0.7067034521879918 0.7067023478588437 -1.1523772660594622e-07 -0.09977159556070928 -2.2295 0.7067035740228393 0.7067024711970205 -1.1338167541473376e-07 -0.0997716648665098 -2.2296 0.7067036958406339 0.7067025944778988 -1.1150997961291431e-07 -0.09977173415130458 -2.2297000000000002 0.7067038176415489 0.7067027177013274 -1.096230753377253e-07 -0.09977180341509995 -2.2298 0.7067039394257538 0.7067028408671598 -1.0772140211605385e-07 -0.09977187265790227 -2.2299 0.706704061193413 0.706702963975254 -1.0580540275167971e-07 -0.09977194187971794 -2.23 0.7067041829446856 0.7067030870254729 -1.0387552320124255e-07 -0.0997720110805532 -2.2300999999999997 0.706704304679727 0.7067032100176844 -1.0193221248577106e-07 -0.09977208026041451 -2.2302000000000004 0.7067044263986865 0.7067033329517614 -9.997592260307941e-08 -0.09977214941930813 -2.2303 0.7067045481017092 0.7067034558275809 -9.800710839506094e-08 -0.09977221855724047 -2.2304 0.7067046697889351 0.7067035786450255 -9.602622745401301e-08 -0.0997722876742178 -2.2305 0.7067047914604995 0.7067037014039826 -9.403374001681897e-08 -0.0997723567702465 -2.2306 0.7067049131165322 0.7067038241043444 -9.203010885652785e-08 -0.09977242584533286 -2.2307 0.7067050347571585 0.7067039467460084 -9.001579917740365e-08 -0.09977249489948326 -2.2308000000000003 0.7067051563824984 0.7067040693288771 -8.799127850563776e-08 -0.09977256393270398 -2.2309 0.7067052779926669 0.7067041918528576 -8.595701657052035e-08 -0.09977263294500141 -2.231 0.7067053995877742 0.7067043143178626 -8.391348521857162e-08 -0.09977270193638188 -2.2311 0.706705521167925 0.7067044367238096 -8.18611582808354e-08 -0.09977277090685166 -2.2312000000000003 0.7067056427332189 0.706704559070621 -7.980051147920414e-08 -0.0997728398564171 -2.2313 0.7067057642837504 0.7067046813582247 -7.773202230585557e-08 -0.09977290878508449 -2.2314000000000003 0.7067058858196096 0.706704803586554 -7.565616991483254e-08 -0.09977297769286023 -2.2315 0.70670600734088 0.7067049257555464 -7.357343501969427e-08 -0.0997730465797505 -2.2316 0.7067061288476413 0.7067050478651457 -7.148429977382048e-08 -0.09977311544576173 -2.2317000000000005 0.706706250339967 0.7067051699153 -6.9389247656787e-08 -0.09977318429090021 -2.2318000000000002 0.7067063718179265 0.7067052919059632 -6.728876336507816e-08 -0.0997732531151723 -2.2319 0.7067064932815825 0.7067054138370941 -6.518333270713605e-08 -0.09977332191858423 -2.232 0.7067066147309937 0.7067055357086568 -6.307344248279723e-08 -0.09977339070114234 -2.2321 0.7067067361662129 0.7067056575206205 -6.095958036923463e-08 -0.09977345946285293 -2.2322 0.7067068575872879 0.7067057792729601 -5.884223481730788e-08 -0.09977352820372233 -2.2323000000000004 0.7067069789942613 0.7067059009656552 -5.6721894931216835e-08 -0.0997735969237568 -2.2324 0.7067071003871701 0.7067060225986908 -5.4599050358129786e-08 -0.09977366562296264 -2.2325 0.7067072217660466 0.7067061441720575 -5.2474191176076976e-08 -0.09977373430134619 -2.2325999999999997 0.7067073431309174 0.7067062656857505 -5.0347807777724116e-08 -0.09977380295891372 -2.2327000000000004 0.7067074644818041 0.706706387139771 -4.8220390759783766e-08 -0.09977387159567155 -2.2328 0.7067075858187224 0.7067065085341251 -4.6092430809065686e-08 -0.09977394021162594 -2.2329 0.7067077071416837 0.7067066298688242 -4.3964418591400326e-08 -0.09977400880678323 -2.233 0.7067078284506932 0.7067067511438849 -4.183684463479571e-08 -0.09977407738114964 -2.2331 0.7067079497457514 0.706706872359329 -3.9710199218896246e-08 -0.09977414593473148 -2.2332 0.7067080710268536 0.7067069935151838 -3.758497226164295e-08 -0.09977421446753504 -2.2333000000000003 0.7067081922939895 0.7067071146114818 -3.546165320579813e-08 -0.09977428297956664 -2.2334 0.7067083135471435 0.7067072356482608 -3.334073090765881e-08 -0.09977435147083252 -2.2335 0.7067084347862951 0.7067073566255633 -3.1222693524374234e-08 -0.09977441994133893 -2.2336 0.7067085560114186 0.7067074775434377 -2.910802839842415e-08 -0.09977448839109224 -2.2337000000000002 0.7067086772224827 0.7067075984019373 -2.6997221949740663e-08 -0.09977455682009867 -2.2338 0.706708798419451 0.7067077192011207 -2.489075956110809e-08 -0.09977462522836451 -2.2339 0.706708919602282 0.7067078399410518 -2.2789125469959565e-08 -0.09977469361589601 -2.234 0.7067090407709291 0.7067079606217992 -2.069280265193374e-08 -0.09977476198269944 -2.2340999999999998 0.7067091619253403 0.7067080812434372 -1.860227271440612e-08 -0.0997748303287811 -2.2342000000000004 0.7067092830654584 0.706708201806045 -1.651801578373205e-08 -0.09977489865414718 -2.2343 0.7067094041912216 0.706708322309707 -1.4440510395091755e-08 -0.09977496695880407 -2.2344 0.7067095253025623 0.7067084427545127 -1.2370233384503826e-08 -0.09977503524275791 -2.2345 0.7067096463994083 0.7067085631405569 -1.0307659779537626e-08 -0.09977510350601505 -2.2346 0.7067097674816819 0.7067086834679389 -8.253262685255225e-09 -0.0997751717485817 -2.2347 0.7067098885493008 0.7067088037367637 -6.207513177092228e-09 -0.09977523997046417 -2.2348000000000003 0.7067100096021772 0.7067089239471411 -4.170880201111171e-09 -0.09977530817166869 -2.2349 0.7067101306402186 0.7067090440991854 -2.143830459509777e-09 -0.09977537635220146 -2.235 0.7067102516633272 0.706709164193017 -1.2682830220073216e-10 -0.09977544451206877 -2.2351 0.7067103726714007 0.7067092842287598 1.87966437380227e-09 -0.09977551265127685 -2.2352000000000003 0.7067104936643316 0.7067094042065439 3.875188239743643e-09 -0.09977558076983195 -2.2353 0.7067106146420075 0.7067095241265038 5.859286622729443e-09 -0.09977564886774037 -2.2354000000000003 0.7067107356043112 0.7067096439887788 7.831505630627456e-09 -0.09977571694500832 -2.2355 0.7067108565511208 0.7067097637935131 9.791394240538098e-09 -0.09977578500164207 -2.2356 0.706710977482309 0.7067098835408556 1.173850441502089e-08 -0.09977585303764779 -2.2357000000000005 0.7067110983977445 0.7067100032309603 1.3672391190565347e-08 -0.0997759210530318 -2.2358000000000002 0.7067112192972907 0.7067101228639856 1.5592612789480653e-08 -0.0997759890478003 -2.2359 0.7067113401808065 0.7067102424400946 1.7498730714438082e-08 -0.09977605702195949 -2.236 0.706711461048146 0.7067103619594551 1.9390309850819687e-08 -0.0997761249755156 -2.2361 0.706711581899159 0.7067104814222399 2.1266918569066984e-08 -0.09977619290847493 -2.2362 0.7067117027336904 0.7067106008286259 2.3128128821825467e-08 -0.09977626082084369 -2.2363000000000004 0.7067118235515808 0.7067107201787947 2.4973516242823846e-08 -0.09977632871262805 -2.2364 0.7067119443526656 0.7067108394729322 2.6802660226671327e-08 -0.09977639658383425 -2.2365 0.706712065136777 0.7067109587112297 2.8615144051155617e-08 -0.0997764644344686 -2.2365999999999997 0.7067121859037415 0.7067110778938815 3.041055495443812e-08 -0.09977653226453721 -2.2367000000000004 0.706712306653382 0.7067111970210875 3.2188484242606785e-08 -0.09977660007404641 -2.2368 0.7067124273855165 0.7067113160930513 3.3948527366003955e-08 -0.09977666786300232 -2.2369 0.706712548099959 0.7067114351099808 3.569028402851393e-08 -0.09977673563141114 -2.237 0.7067126687965195 0.7067115540720884 3.7413358258686635e-08 -0.0997768033792792 -2.2371 0.7067127894750036 0.7067116729795904 3.91173585190252e-08 -0.09977687110661262 -2.2372 0.7067129101352128 0.7067117918327075 4.080189779098742e-08 -0.09977693881341765 -2.2373000000000003 0.7067130307769438 0.7067119106316644 4.2466593646109385e-08 -0.09977700649970045 -2.2374 0.7067131513999905 0.7067120293766899 4.411106835182366e-08 -0.09977707416546733 -2.2375 0.7067132720041418 0.7067121480680166 4.57349489425829e-08 -0.09977714181072439 -2.2376 0.7067133925891831 0.7067122667058812 4.733786732741274e-08 -0.09977720943547787 -2.2377000000000002 0.7067135131548958 0.7067123852905244 4.8919460354096556e-08 -0.09977727703973398 -2.2378 0.7067136337010578 0.7067125038221904 5.047936989244217e-08 -0.09977734462349891 -2.2379000000000002 0.7067137542274421 0.7067126223011276 5.2017242908874994e-08 -0.09977741218677884 -2.238 0.7067138747338194 0.7067127407275876 5.3532731568786684e-08 -0.09977747972957997 -2.2380999999999998 0.7067139952199559 0.7067128591018262 5.502549329725048e-08 -0.09977754725190853 -2.2382000000000004 0.7067141156856144 0.7067129774241026 5.6495190867492107e-08 -0.09977761475377067 -2.2383 0.7067142361305538 0.7067130956946793 5.7941492468543965e-08 -0.09977768223517261 -2.2384 0.7067143565545303 0.7067132139138228 5.93640717746341e-08 -0.09977774969612052 -2.2385 0.706714476957296 0.7067133320818024 6.07626080284529e-08 -0.09977781713662055 -2.2386 0.7067145973385996 0.7067134501988916 6.213678611748097e-08 -0.09977788455667902 -2.2387 0.706714717698187 0.7067135682653665 6.348629662950023e-08 -0.09977795195630196 -2.2388000000000003 0.7067148380358004 0.7067136862815065 6.481083595667736e-08 -0.09977801933549563 -2.2389 0.7067149583511786 0.7067138042475946 6.611010631117631e-08 -0.09977808669426617 -2.239 0.7067150786440579 0.7067139221639165 6.738381582577224e-08 -0.09977815403261978 -2.2391 0.7067151989141713 0.7067140400307612 6.863167861803632e-08 -0.09977822135056261 -2.2392000000000003 0.7067153191612487 0.7067141578484205 6.985341484411212e-08 -0.09977828864810084 -2.2393 0.7067154393850172 0.7067142756171896 7.104875078198236e-08 -0.09977835592524066 -2.2394000000000003 0.7067155595852006 0.7067143933373659 7.221741886095923e-08 -0.09977842318198826 -2.2395 0.7067156797615206 0.7067145110092501 7.335915774321633e-08 -0.09977849041834976 -2.2396 0.7067157999136957 0.7067146286331454 7.447371237062628e-08 -0.09977855763433136 -2.2397000000000005 0.7067159200414419 0.7067147462093577 7.556083403414959e-08 -0.09977862482993921 -2.2398000000000002 0.7067160401444725 0.7067148637381953 7.662028043628477e-08 -0.09977869200517941 -2.2399 0.7067161602224985 0.7067149812199693 7.765181571882385e-08 -0.0997787591600583 -2.24 0.706716280275228 0.7067150986549932 7.865521052530244e-08 -0.09977882629458182 -2.2401 0.706716400302367 0.7067152160435827 7.963024206518454e-08 -0.09977889340875624 -2.2402 0.7067165203036194 0.7067153333860561 8.057669413120971e-08 -0.09977896050258774 -2.2403000000000004 0.7067166402786864 0.7067154506827336 8.149435718786402e-08 -0.09977902757608237 -2.2404 0.7067167602272673 0.7067155679339376 8.238302840433975e-08 -0.09977909462924633 -2.2405 0.7067168801490594 0.7067156851399934 8.324251169096464e-08 -0.09977916166208582 -2.2405999999999997 0.7067170000437579 0.7067158023012269 8.407261773216157e-08 -0.09977922867460695 -2.2407000000000004 0.7067171199110559 0.7067159194179669 8.487316405410283e-08 -0.09977929566681581 -2.2408 0.7067172397506445 0.706716036490544 8.5643975031649e-08 -0.09977936263871864 -2.2409 0.7067173595622137 0.7067161535192902 8.638488197681982e-08 -0.09977942959032153 -2.241 0.7067174793454509 0.7067162705045396 8.709572312665115e-08 -0.09977949652163061 -2.2411 0.7067175991000423 0.7067163874466278 8.777634369350196e-08 -0.09977956343265204 -2.2412 0.7067177188256725 0.7067165043458922 8.84265959240349e-08 -0.09977963032339195 -2.2413000000000003 0.7067178385220245 0.7067166212026712 8.904633909054271e-08 -0.09977969719385646 -2.2414 0.7067179581887801 0.706716738017305 8.963543953605102e-08 -0.09977976404405173 -2.2415 0.7067180778256192 0.7067168547901348 9.019377073329893e-08 -0.09977983087398384 -2.2416 0.7067181974322214 0.7067169715215038 9.07212132604529e-08 -0.09977989768365898 -2.2417000000000002 0.7067183170082638 0.7067170882117557 9.121765486702627e-08 -0.09977996447308325 -2.2418 0.7067184365534236 0.7067172048612353 9.168299046694028e-08 -0.09978003124226278 -2.2419000000000002 0.7067185560673761 0.7067173214702891 9.211712220097423e-08 -0.09978009799120365 -2.242 0.7067186755497964 0.7067174380392639 9.251995939166258e-08 -0.09978016471991208 -2.2420999999999998 0.7067187950003577 0.7067175545685075 9.289141863003114e-08 -0.0997802314283941 -2.2422000000000004 0.7067189144187337 0.7067176710583686 9.323142378253602e-08 -0.09978029811665587 -2.2423 0.7067190338045961 0.7067177875091968 9.353990595983852e-08 -0.09978036478470349 -2.2424 0.7067191531576167 0.706717903921342 9.381680357231637e-08 -0.09978043143254309 -2.2425 0.7067192724774661 0.7067180202951548 9.40620623196553e-08 -0.0997804980601807 -2.2426 0.7067193917638155 0.7067181366309866 9.427563522207416e-08 -0.09978056466762254 -2.2427 0.7067195110163346 0.7067182529291887 9.445748260991649e-08 -0.09978063125487467 -2.2428000000000003 0.7067196302346932 0.7067183691901127 9.460757213752835e-08 -0.09978069782194318 -2.2429 0.7067197494185609 0.7067184854141113 9.472587881101391e-08 -0.09978076436883418 -2.243 0.706719868567607 0.7067186016015363 9.481238495354094e-08 -0.09978083089555381 -2.2431 0.7067199876815009 0.7067187177527405 9.486708019840195e-08 -0.09978089740210813 -2.2432000000000003 0.7067201067599116 0.7067188338680761 9.488996155840312e-08 -0.0997809638885033 -2.2433 0.7067202258025085 0.7067189499478954 9.48810333530059e-08 -0.09978103035474536 -2.2434000000000003 0.7067203448089607 0.7067190659925509 9.48403072499604e-08 -0.09978109680084041 -2.2435 0.7067204637789379 0.7067191820023944 9.476780223408032e-08 -0.09978116322679456 -2.2436 0.7067205827121104 0.7067192979777774 9.466354461071247e-08 -0.09978122963261393 -2.2437000000000005 0.7067207016081478 0.7067194139190514 9.452756799532835e-08 -0.09978129601830453 -2.2438000000000002 0.7067208204667214 0.7067195298265672 9.435991331005478e-08 -0.09978136238387247 -2.2439 0.7067209392875021 0.7067196457006752 9.416062876632658e-08 -0.09978142872932393 -2.244 0.7067210580701618 0.7067197615417251 9.392976984060053e-08 -0.09978149505466488 -2.2441 0.7067211768143733 0.7067198773500657 9.36673992743553e-08 -0.0997815613599014 -2.2442 0.7067212955198094 0.7067199931260455 9.337358707756094e-08 -0.09978162764503967 -2.2443 0.7067214141861449 0.7067201088700119 9.304841045928991e-08 -0.09978169391008573 -2.2444 0.706721532813054 0.7067202245823112 9.269195384506435e-08 -0.09978176015504558 -2.2445 0.7067216514002137 0.7067203402632893 9.230430883522267e-08 -0.09978182637992541 -2.2445999999999997 0.7067217699473004 0.7067204559132902 9.188557420491961e-08 -0.09978189258473126 -2.2447000000000004 0.7067218884539925 0.7067205715326574 9.143585585902336e-08 -0.09978195876946915 -2.2448 0.7067220069199693 0.7067206871217329 9.095526682517674e-08 -0.09978202493414517 -2.2449 0.7067221253449121 0.7067208026808574 9.044392720175543e-08 -0.09978209107876544 -2.245 0.7067222437285027 0.7067209182103701 8.990196413705132e-08 -0.09978215720333598 -2.2451 0.7067223620704245 0.706721033710609 8.932951180151694e-08 -0.09978222330786284 -2.2452 0.7067224803703629 0.7067211491819105 8.872671136000987e-08 -0.09978228939235206 -2.2453000000000003 0.7067225986280046 0.7067212646246093 8.809371092322049e-08 -0.09978235545680977 -2.2454 0.7067227168430379 0.7067213800390384 8.743066550950807e-08 -0.099782421501242 -2.2455 0.7067228350151528 0.7067214954255294 8.673773704663545e-08 -0.09978248752565479 -2.2456 0.7067229531440415 0.7067216107844119 8.60150942885024e-08 -0.09978255353005423 -2.2457000000000003 0.7067230712293979 0.7067217261160131 8.526291277004272e-08 -0.09978261951444639 -2.2458 0.7067231892709176 0.7067218414206589 8.448137479855067e-08 -0.09978268547883726 -2.2459000000000002 0.7067233072682985 0.7067219566986727 8.36706693825573e-08 -0.09978275142323292 -2.246 0.7067234252212407 0.7067220719503761 8.283099220060541e-08 -0.09978281734763944 -2.2460999999999998 0.7067235431294461 0.7067221871760884 8.196254556655513e-08 -0.09978288325206282 -2.2462000000000004 0.7067236609926193 0.7067223023761264 8.106553834805186e-08 -0.09978294913650913 -2.2463 0.706723778810467 0.7067224175508051 8.014018594224015e-08 -0.09978301500098441 -2.2464 0.7067238965826981 0.7067225327004368 7.918671020984425e-08 -0.09978308084549474 -2.2465 0.7067240143090243 0.7067226478253312 7.820533942312635e-08 -0.09978314667004609 -2.2466 0.7067241319891596 0.7067227629257956 7.719630822425327e-08 -0.09978321247464451 -2.2467 0.7067242496228208 0.7067228780021346 7.615985754723387e-08 -0.09978327825929606 -2.2468000000000004 0.7067243672097272 0.7067229930546504 7.50962345936329e-08 -0.09978334402400674 -2.2469 0.7067244847496007 0.7067231080836421 7.400569274756963e-08 -0.09978340976878258 -2.247 0.7067246022421664 0.7067232230894065 7.288849151500243e-08 -0.09978347549362965 -2.2471 0.7067247196871519 0.7067233380722371 7.174489647689131e-08 -0.09978354119855398 -2.2472000000000003 0.7067248370842878 0.7067234530324249 7.057517921113532e-08 -0.09978360688356158 -2.2473 0.7067249544333079 0.7067235679702573 6.937961723879615e-08 -0.09978367254865847 -2.2474000000000003 0.7067250717339486 0.7067236828860188 6.815849395297446e-08 -0.09978373819385065 -2.2475 0.7067251889859499 0.7067237977799913 6.691209855115565e-08 -0.0997838038191442 -2.2476 0.706725306189055 0.7067239126524529 6.564072597449455e-08 -0.09978386942454509 -2.2477000000000005 0.7067254233430096 0.706724027503679 6.434467683148759e-08 -0.09978393501005937 -2.2478000000000002 0.7067255404475634 0.706724142333941 6.302425733031858e-08 -0.09978400057569299 -2.2479 0.7067256575024695 0.7067242571435077 6.167977920773504e-08 -0.09978406612145205 -2.248 0.7067257745074838 0.7067243719326441 6.031155964057733e-08 -0.0997841316473425 -2.2481 0.7067258914623662 0.7067244867016118 5.8919921190267455e-08 -0.09978419715337039 -2.2482 0.7067260083668798 0.7067246014506685 5.750519171780766e-08 -0.09978426263954167 -2.2483 0.7067261252207915 0.7067247161800693 5.606770429704422e-08 -0.09978432810586241 -2.2484 0.7067262420238716 0.7067248308900644 5.4607797169564654e-08 -0.09978439355233856 -2.2485 0.7067263587758945 0.706724945580901 5.312581363887958e-08 -0.09978445897897613 -2.2485999999999997 0.706726475476638 0.7067250602528228 5.1622101975012935e-08 -0.09978452438578113 -2.2487000000000004 0.7067265921258838 0.7067251749060692 5.009701537286859e-08 -0.09978458977275963 -2.2488 0.7067267087234177 0.7067252895408758 4.855091183773863e-08 -0.09978465513991754 -2.2489 0.7067268252690289 0.7067254041574744 4.698415410550605e-08 -0.09978472048726088 -2.249 0.7067269417625106 0.706725518756093 4.5397109574990546e-08 -0.09978478581479562 -2.2491 0.7067270582036606 0.7067256333369553 4.379015020039567e-08 -0.0997848511225278 -2.2492 0.7067271745922801 0.706725747900281 4.216365242365461e-08 -0.09978491641046337 -2.2493000000000003 0.7067272909281748 0.7067258624462858 4.05179970807551e-08 -0.09978498167860833 -2.2494 0.7067274072111542 0.7067259769751817 3.8853569299390767e-08 -0.09978504692696871 -2.2495 0.7067275234410324 0.7067260914871751 3.717075841916384e-08 -0.09978511215555042 -2.2496 0.7067276396176274 0.7067262059824699 3.546995790484897e-08 -0.09978517736435949 -2.2497000000000003 0.7067277557407614 0.7067263204612648 3.375156524577927e-08 -0.09978524255340188 -2.2498 0.7067278718102611 0.7067264349237543 3.201598186737542e-08 -0.0997853077226836 -2.2499000000000002 0.7067279878259578 0.7067265493701281 3.026361303920533e-08 -0.09978537287221056 -2.25 0.7067281037876865 0.7067266638005725 2.8494867767431264e-08 -0.0997854380019888 -2.2500999999999998 0.7067282196952873 0.7067267782152685 2.6710158721951482e-08 -0.09978550311202425 -2.2502000000000004 0.7067283355486045 0.7067268926143931 2.4909902125377914e-08 -0.09978556820232291 -2.2503 0.7067284513474869 0.7067270069981186 2.309451765242221e-08 -0.09978563327289072 -2.2504 0.706728567091788 0.7067271213666126 2.1264428351833176e-08 -0.0997856983237337 -2.2505 0.7067286827813659 0.7067272357200386 1.9420060524966143e-08 -0.09978576335485784 -2.2506 0.7067287984160828 0.7067273500585547 1.7561843634709973e-08 -0.09978582836626898 -2.2507 0.7067289139958062 0.7067274643823152 1.5690210206607824e-08 -0.0997858933579732 -2.2508000000000004 0.7067290295204078 0.7067275786914691 1.3805595736049447e-08 -0.09978595832997637 -2.2509 0.7067291449897644 0.7067276929861611 1.1908438567707902e-08 -0.09978602328228453 -2.251 0.7067292604037572 0.7067278072665308 9.999179814007553e-09 -0.0997860882149036 -2.2511 0.7067293757622723 0.7067279215327132 8.078263244101769e-09 -0.09978615312783956 -2.2512000000000003 0.7067294910652007 0.7067280357848387 6.146135178922152e-09 -0.0997862180210983 -2.2513 0.706729606312438 0.7067281500230322 4.203244387095129e-09 -0.09978628289468582 -2.2514000000000003 0.706729721503885 0.7067282642474149 2.250041989532159e-09 -0.09978634774860812 -2.2515 0.706729836639447 0.7067283784581018 2.869813397338161e-10 -0.09978641258287105 -2.2516 0.7067299517190344 0.706728492655204 -1.6854820707526419e-09 -0.09978647739748062 -2.2517000000000005 0.7067300667425622 0.706728606838827 -3.666890716416682e-09 -0.09978654219244273 -2.2518000000000002 0.7067301817099507 0.7067287210090718 -5.6567851531436064e-09 -0.09978660696776333 -2.2519 0.7067302966211253 0.7067288351660346 -7.654704117961153e-09 -0.0997866717234484 -2.252 0.7067304114760158 0.7067289493098061 -9.660184633122904e-09 -0.09978673645950387 -2.2521 0.7067305262745573 0.7067290634404725 -1.1672762121467395e-08 -0.09978680117593568 -2.2522 0.70673064101669 0.7067291775581144 -1.3691970507465762e-08 -0.09978686587274971 -2.2523 0.7067307557023589 0.7067292916628076 -1.5717342330412443e-08 -0.09978693054995193 -2.2524 0.7067308703315143 0.7067294057546236 -1.7748408845906505e-08 -0.09978699520754833 -2.2525 0.706730984904111 0.7067295198336279 -1.9784700142078115e-08 -0.09978705984554473 -2.2525999999999997 0.7067310994201097 0.7067296338998811 -2.182574524367195e-08 -0.09978712446394715 -2.2527000000000004 0.7067312138794755 0.7067297479534389 -2.3871072220033734e-08 -0.09978718906276146 -2.2528 0.7067313282821788 0.7067298619943523 -2.5920208296566216e-08 -0.09978725364199362 -2.2529 0.7067314426281952 0.7067299760226664 -2.7972679964884117e-08 -0.0997873182016496 -2.253 0.706731556917505 0.706730090038422 -3.00280130888491e-08 -0.09978738274173522 -2.2531 0.7067316711500939 0.7067302040416541 -3.208573301385735e-08 -0.09978744726225644 -2.2532 0.7067317853259528 0.706730318032393 -3.414536468133132e-08 -0.09978751176321915 -2.2533000000000003 0.7067318994450775 0.7067304320106638 -3.620643273377893e-08 -0.09978757624462933 -2.2534 0.7067320135074687 0.7067305459764864 -3.826846162733374e-08 -0.09978764070649282 -2.2535 0.706732127513133 0.7067306599298762 -4.0330975738223605e-08 -0.09978770514881563 -2.2536 0.7067322414620811 0.7067307738708427 -4.2393499476286664e-08 -0.09978776957160365 -2.2537000000000003 0.7067323553543297 0.7067308877993903 -4.4455557390423524e-08 -0.09978783397486274 -2.2538 0.7067324691898995 0.7067310017155188 -4.651667428226232e-08 -0.09978789835859879 -2.2539000000000002 0.7067325829688171 0.7067311156192227 -4.857637531270869e-08 -0.0997879627228177 -2.254 0.7067326966911145 0.7067312295104913 -5.063418611250727e-08 -0.09978802706752543 -2.2540999999999998 0.706732810356828 0.706731343389309 -5.2689632891542854e-08 -0.0997880913927279 -2.2542000000000004 0.7067329239659994 0.7067314572556549 -5.474224254627125e-08 -0.09978815569843097 -2.2543 0.7067330375186756 0.706731571109503 -5.6791542771663164e-08 -0.09978821998464053 -2.2544 0.7067331510149082 0.7067316849508225 -5.883706216702235e-08 -0.09978828425136249 -2.2545 0.7067332644547539 0.7067317987795776 -6.087833034559842e-08 -0.09978834849860273 -2.2546 0.7067333778382747 0.7067319125957269 -6.291487804300708e-08 -0.09978841272636713 -2.2547 0.7067334911655381 0.7067320263992246 -6.494623722283141e-08 -0.09978847693466164 -2.2548000000000004 0.7067336044366156 0.7067321401900197 -6.697194118807787e-08 -0.09978854112349213 -2.2549 0.706733717651584 0.706732253968056 -6.899152468417546e-08 -0.09978860529286446 -2.255 0.7067338308105252 0.7067323677332724 -7.10045240121665e-08 -0.09978866944278454 -2.2551 0.7067339439135263 0.7067324814856032 -7.301047712324898e-08 -0.09978873357325826 -2.2552000000000003 0.7067340569606788 0.7067325952249772 -7.500892373760518e-08 -0.09978879768429148 -2.2553 0.7067341699520798 0.7067327089513187 -7.699940544371453e-08 -0.09978886177589014 -2.2554000000000003 0.7067342828878306 0.7067328226645466 -7.898146580503917e-08 -0.09978892584806001 -2.2555 0.7067343957680376 0.7067329363645756 -8.095465046063788e-08 -0.09978898990080705 -2.2556 0.7067345085928123 0.7067330500513149 -8.291850723662203e-08 -0.09978905393413708 -2.2557000000000005 0.7067346213622706 0.7067331637246694 -8.487258624373384e-08 -0.099789117948056 -2.2558000000000002 0.7067347340765338 0.706733277384539 -8.681643998576655e-08 -0.09978918194256971 -2.2559 0.7067348467357271 0.7067333910308187 -8.874962345497422e-08 -0.09978924591768405 -2.256 0.7067349593399816 0.7067335046633988 -9.06716942378899e-08 -0.09978930987340491 -2.2561 0.7067350718894321 0.7067336182821649 -9.258221261767424e-08 -0.09978937380973814 -2.2562 0.7067351843842185 0.706733731886998 -9.4480741668658e-08 -0.0997894377266896 -2.2563 0.7067352968244853 0.7067338454777742 -9.636684736823165e-08 -0.09978950162426516 -2.2564 0.7067354092103817 0.7067339590543653 -9.824009868184685e-08 -0.09978956550247067 -2.2565 0.7067355215420612 0.7067340726166383 -1.001000676714367e-07 -0.099789629361312 -2.2565999999999997 0.7067356338196823 0.7067341861644558 -1.0194632959256017e-07 -0.09978969320079502 -2.2567000000000004 0.7067357460434076 0.7067342996976755 -1.0377846298027099e-07 -0.09978975702092553 -2.2568 0.7067358582134045 0.7067344132161513 -1.05596049762742e-07 -0.09978982082170947 -2.2569 0.7067359703298446 0.706734526719732 -1.0739867534366454e-07 -0.09978988460315263 -2.257 0.7067360823929041 0.7067346402082622 -1.0918592870112764e-07 -0.09978994836526094 -2.2571 0.7067361944027635 0.7067347536815819 -1.1095740247782371e-07 -0.0997900121080401 -2.2572 0.7067363063596072 0.7067348671395275 -1.1271269308339715e-07 -0.09979007583149607 -2.2573000000000003 0.7067364182636247 0.7067349805819303 -1.1445140076817018e-07 -0.09979013953563468 -2.2574 0.7067365301150093 0.7067350940086179 -1.1617312974630811e-07 -0.09979020322046174 -2.2575 0.7067366419139585 0.7067352074194133 -1.178774882443917e-07 -0.09979026688598318 -2.2576 0.7067367536606739 0.7067353208141358 -1.1956408861937828e-07 -0.09979033053220476 -2.2577000000000003 0.7067368653553612 0.7067354341926001 -1.2123254744013379e-07 -0.09979039415913234 -2.2578 0.7067369769982303 0.706735547554617 -1.2288248557416892e-07 -0.09979045776677174 -2.2579000000000002 0.7067370885894952 0.7067356608999933 -1.2451352826570172e-07 -0.09979052135512881 -2.258 0.7067372001293735 0.7067357742285321 -1.2612530523627152e-07 -0.09979058492420936 -2.2580999999999998 0.7067373116180868 0.7067358875400318 -1.2771745075412788e-07 -0.09979064847401924 -2.2582000000000004 0.7067374230558612 0.7067360008342882 -1.2928960372790566e-07 -0.09979071200456432 -2.2583 0.7067375344429259 0.7067361141110922 -1.308414077794834e-07 -0.09979077551585037 -2.2584 0.7067376457795138 0.706736227370231 -1.323725113393931e-07 -0.09979083900788327 -2.2585 0.706737757065862 0.7067363406114886 -1.3388256769886198e-07 -0.09979090248066878 -2.2586 0.7067378683022111 0.7067364538346451 -1.353712351208347e-07 -0.09979096593421276 -2.2587 0.7067379794888051 0.7067365670394767 -1.3683817689201516e-07 -0.09979102936852098 -2.2588000000000004 0.7067380906258919 0.7067366802257568 -1.38283061413072e-07 -0.09979109278359936 -2.2589 0.7067382017137226 0.7067367933932542 -1.3970556227323183e-07 -0.09979115617945361 -2.259 0.7067383127525517 0.7067369065417354 -1.4110535831619864e-07 -0.0997912195560896 -2.2591 0.7067384237426375 0.7067370196709629 -1.4248213372168583e-07 -0.09979128291351319 -2.2592000000000003 0.7067385346842412 0.7067371327806959 -1.438355780609274e-07 -0.09979134625173014 -2.2593 0.7067386455776272 0.7067372458706902 -1.4516538637647514e-07 -0.09979140957074625 -2.2594000000000003 0.7067387564230636 0.7067373589406987 -1.4647125926720017e-07 -0.09979147287056733 -2.2595 0.706738867220821 0.7067374719904711 -1.477529029247221e-07 -0.09979153615119918 -2.2596 0.7067389779711738 0.7067375850197539 -1.490100292218799e-07 -0.09979159941264763 -2.2597000000000005 0.7067390886743989 0.7067376980282907 -1.502423557699778e-07 -0.09979166265491851 -2.2598000000000003 0.7067391993307761 0.706737811015822 -1.5144960597950063e-07 -0.09979172587801756 -2.2599 0.7067393099405883 0.7067379239820853 -1.5263150912950274e-07 -0.09979178908195058 -2.26 0.7067394205041214 0.7067380369268157 -1.5378780041618023e-07 -0.09979185226672341 -2.2601 0.7067395310216641 0.7067381498497451 -1.5491822102225994e-07 -0.09979191543234187 -2.2602 0.7067396414935072 0.7067382627506028 -1.5602251818465362e-07 -0.09979197857881164 -2.2603 0.7067397519199445 0.7067383756291157 -1.5710044522221356e-07 -0.09979204170613865 -2.2604 0.7067398623012726 0.7067384884850079 -1.5815176161379507e-07 -0.0997921048143286 -2.2605 0.7067399726377903 0.7067386013180005 -1.5917623304335937e-07 -0.0997921679033873 -2.2605999999999997 0.7067400829297992 0.706738714127813 -1.6017363146068886e-07 -0.09979223097332052 -2.2607000000000004 0.7067401931776025 0.7067388269141623 -1.6114373511434688e-07 -0.09979229402413407 -2.2608 0.7067403033815065 0.7067389396767629 -1.6208632862106664e-07 -0.09979235705583372 -2.2609 0.7067404135418194 0.7067390524153271 -1.630012030056499e-07 -0.0997924200684253 -2.261 0.7067405236588518 0.7067391651295647 -1.6388815573219195e-07 -0.09979248306191453 -2.2611 0.7067406337329158 0.7067392778191841 -1.6474699077520527e-07 -0.09979254603630727 -2.2612 0.7067407437643262 0.7067393904838911 -1.655775186525793e-07 -0.09979260899160922 -2.2613000000000003 0.7067408537533993 0.7067395031233898 -1.6637955645680547e-07 -0.0997926719278262 -2.2614 0.7067409637004536 0.706739615737382 -1.6715292789834524e-07 -0.09979273484496398 -2.2615 0.706741073605809 0.7067397283255683 -1.6789746335593714e-07 -0.0997927977430283 -2.2616 0.7067411834697875 0.7067398408876471 -1.686129999112912e-07 -0.09979286062202491 -2.2617000000000003 0.7067412932927125 0.7067399534233153 -1.6929938137164036e-07 -0.09979292348195964 -2.2618 0.7067414030749093 0.7067400659322683 -1.6995645832004747e-07 -0.09979298632283823 -2.2619000000000002 0.7067415128167043 0.7067401784141999 -1.7058408813448722e-07 -0.0997930491446664 -2.262 0.7067416225184258 0.7067402908688023 -1.711821350260101e-07 -0.09979311194744997 -2.2620999999999998 0.7067417321804033 0.7067404032957667 -1.7175047006302846e-07 -0.0997931747311947 -2.2622000000000004 0.7067418418029673 0.7067405156947826 -1.7228897121468467e-07 -0.09979323749590631 -2.2623 0.7067419513864499 0.7067406280655382 -1.727975233456469e-07 -0.0997933002415906 -2.2624 0.7067420609311843 0.7067407404077211 -1.732760182785592e-07 -0.0997933629682533 -2.2625 0.7067421704375048 0.7067408527210176 -1.7372435477669423e-07 -0.09979342567590024 -2.2626 0.7067422799057463 0.7067409650051126 -1.7414243859079082e-07 -0.09979348836453707 -2.2627 0.7067423893362453 0.7067410772596907 -1.7453018249721786e-07 -0.09979355103416965 -2.2628000000000004 0.7067424987293385 0.7067411894844349 -1.7488750628236183e-07 -0.0997936136848036 -2.2629 0.7067426080853636 0.7067413016790278 -1.7521433674783093e-07 -0.09979367631644477 -2.263 0.7067427174046589 0.7067414138431517 -1.7551060776249683e-07 -0.09979373892909882 -2.2631 0.7067428266875636 0.7067415259764875 -1.7577626025208626e-07 -0.09979380152277154 -2.2632000000000003 0.7067429359344174 0.7067416380787165 -1.7601124224428388e-07 -0.09979386409746868 -2.2633 0.7067430451455601 0.7067417501495186 -1.762155088270989e-07 -0.09979392665319596 -2.2634000000000003 0.7067431543213325 0.7067418621885735 -1.7638902219049846e-07 -0.09979398918995913 -2.2635 0.706743263462075 0.7067419741955612 -1.7653175161946866e-07 -0.09979405170776395 -2.2636 0.7067433725681289 0.7067420861701608 -1.7664367352177024e-07 -0.0997941142066161 -2.2637000000000005 0.7067434816398352 0.7067421981120515 -1.7672477139324405e-07 -0.09979417668652138 -2.2638000000000003 0.7067435906775352 0.7067423100209125 -1.767750358490361e-07 -0.0997942391474855 -2.2639 0.7067436996815701 0.7067424218964224 -1.7679446462706694e-07 -0.09979430158951415 -2.264 0.706743808652281 0.7067425337382607 -1.7678306254986786e-07 -0.09979436401261306 -2.2641 0.7067439175900093 0.7067426455461062 -1.7674084155927527e-07 -0.09979442641678798 -2.2642 0.7067440264950955 0.706742757319639 -1.7666782070949183e-07 -0.09979448880204467 -2.2643 0.7067441353678803 0.7067428690585382 -1.7656402612892252e-07 -0.09979455116838881 -2.2644 0.7067442442087037 0.7067429807624845 -1.7642949103405248e-07 -0.09979461351582612 -2.2645 0.7067443530179056 0.7067430924311583 -1.7626425575373306e-07 -0.0997946758443624 -2.2645999999999997 0.7067444617958252 0.7067432040642405 -1.7606836762509848e-07 -0.09979473815400325 -2.2647000000000004 0.7067445705428008 0.7067433156614129 -1.7584188107336307e-07 -0.0997948004447545 -2.2648 0.7067446792591707 0.7067434272223575 -1.7558485755631015e-07 -0.09979486271662176 -2.2649 0.706744787945272 0.7067435387467578 -1.7529736553306696e-07 -0.0997949249696108 -2.265 0.7067448966014408 0.7067436502342972 -1.749794804987992e-07 -0.09979498720372731 -2.2651 0.7067450052280128 0.7067437616846612 -1.7463128491185254e-07 -0.09979504941897707 -2.2652 0.7067451138253222 0.7067438730975351 -1.742528681902833e-07 -0.0997951116153657 -2.2653000000000003 0.7067452223937027 0.7067439844726054 -1.7384432670491945e-07 -0.09979517379289891 -2.2654 0.7067453309334862 0.7067440958095604 -1.7340576372038008e-07 -0.0997952359515824 -2.2655 0.7067454394450041 0.7067442071080894 -1.7293728942630038e-07 -0.09979529809142192 -2.2656 0.7067455479285863 0.7067443183678823 -1.724390208436566e-07 -0.09979536021242316 -2.2657000000000003 0.7067456563845611 0.7067444295886312 -1.7191108183864379e-07 -0.09979542231459182 -2.2658 0.7067457648132557 0.7067445407700288 -1.7135360307757308e-07 -0.09979548439793354 -2.2659000000000002 0.7067458732149955 0.7067446519117699 -1.707667219973813e-07 -0.09979554646245406 -2.266 0.7067459815901047 0.7067447630135508 -1.701505827761407e-07 -0.0997956085081591 -2.2661 0.7067460899389055 0.7067448740750693 -1.69505336282752e-07 -0.09979567053505434 -2.2662000000000004 0.7067461982617187 0.7067449850960246 -1.6883114006306654e-07 -0.09979573254314543 -2.2663 0.7067463065588632 0.7067450960761184 -1.6812815827917105e-07 -0.0997957945324381 -2.2664 0.7067464148306559 0.7067452070150533 -1.673965616833667e-07 -0.09979585650293804 -2.2665 0.7067465230774124 0.7067453179125347 -1.6663652757827052e-07 -0.09979591845465094 -2.2666 0.706746631299445 0.7067454287682695 -1.6584823975263063e-07 -0.09979598038758244 -2.2667 0.7067467394970657 0.7067455395819665 -1.6503188846744843e-07 -0.09979604230173826 -2.2668000000000004 0.7067468476705827 0.7067456503533371 -1.641876703900591e-07 -0.09979610419712406 -2.2669 0.7067469558203032 0.7067457610820946 -1.6331578855943718e-07 -0.09979616607374553 -2.267 0.7067470639465318 0.7067458717679548 -1.6241645232374646e-07 -0.09979622793160835 -2.2671 0.7067471720495704 0.7067459824106352 -1.6148987729523723e-07 -0.09979628977071817 -2.2672000000000003 0.7067472801297187 0.7067460930098565 -1.6053628531034758e-07 -0.09979635159108069 -2.2673 0.7067473881872742 0.7067462035653411 -1.5955590435337563e-07 -0.09979641339270157 -2.2674000000000003 0.7067474962225317 0.7067463140768147 -1.585489685287239e-07 -0.09979647517558647 -2.2675 0.7067476042357836 0.7067464245440048 -1.5751571797763264e-07 -0.09979653693974111 -2.2676 0.7067477122273192 0.7067465349666422 -1.5645639885389362e-07 -0.09979659868517109 -2.2677000000000005 0.7067478201974253 0.7067466453444601 -1.5537126322150152e-07 -0.09979666041188211 -2.2678000000000003 0.706747928146386 0.7067467556771945 -1.5426056904424557e-07 -0.09979672211987983 -2.2679 0.7067480360744824 0.7067468659645842 -1.5312458009203445e-07 -0.09979678380916994 -2.268 0.7067481439819931 0.706746976206371 -1.5196356587497684e-07 -0.09979684547975803 -2.2681 0.7067482518691932 0.7067470864022997 -1.507778016000133e-07 -0.09979690713164985 -2.2682 0.7067483597363551 0.7067471965521177 -1.495675681032621e-07 -0.09979696876485095 -2.2683 0.7067484675837479 0.7067473066555763 -1.4833315177022188e-07 -0.09979703037936706 -2.2684 0.7067485754116375 0.7067474167124292 -1.470748444698522e-07 -0.09979709197520381 -2.2685 0.7067486832202869 0.7067475267224336 -1.4579294349732763e-07 -0.09979715355236685 -2.2685999999999997 0.7067487910099559 0.7067476366853498 -1.4448775149597526e-07 -0.09979721511086181 -2.2687000000000004 0.7067488987809007 0.7067477466009418 -1.4315957639135513e-07 -0.09979727665069438 -2.2688 0.7067490065333742 0.7067478564689764 -1.4180873130278937e-07 -0.0997973381718702 -2.2689 0.7067491142676257 0.7067479662892244 -1.404355344913205e-07 -0.0997973996743949 -2.269 0.7067492219839014 0.7067480760614596 -1.390403092660364e-07 -0.09979746115827412 -2.2691 0.7067493296824436 0.7067481857854596 -1.376233839216201e-07 -0.09979752262351352 -2.2692 0.7067494373634915 0.7067482954610055 -1.3618509166722637e-07 -0.09979758407011874 -2.2693000000000003 0.7067495450272798 0.706748405087882 -1.3472577052413282e-07 -0.09979764549809535 -2.2694 0.7067496526740407 0.7067485146658774 -1.3324576325635107e-07 -0.09979770690744909 -2.2695 0.7067497603040012 0.7067486241947842 -1.3174541729950306e-07 -0.09979776829818551 -2.2696 0.7067498679173858 0.7067487336743983 -1.302250846740849e-07 -0.09979782967031028 -2.2697000000000003 0.7067499755144147 0.7067488431045192 -1.286851218987306e-07 -0.09979789102382905 -2.2698 0.706750083095304 0.7067489524849508 -1.2712588991041496e-07 -0.09979795235874744 -2.2699000000000003 0.706750190660266 0.7067490618155007 -1.2554775398118667e-07 -0.09979801367507106 -2.27 0.7067502982095095 0.7067491710959801 -1.239510836349017e-07 -0.09979807497280552 -2.2701 0.7067504057432383 0.7067492803262051 -1.2233625254834402e-07 -0.09979813625195649 -2.2702000000000004 0.706750513261653 0.7067493895059951 -1.20703638473163e-07 -0.09979819751252955 -2.2703 0.7067506207649494 0.7067494986351739 -1.1905362315087209e-07 -0.09979825875453034 -2.2704 0.70675072825332 0.7067496077135693 -1.1738659221223469e-07 -0.09979831997796451 -2.2705 0.7067508357269524 0.7067497167410133 -1.1570293510267116e-07 -0.09979838118283763 -2.2706 0.7067509431860304 0.7067498257173424 -1.140030449799101e-07 -0.09979844236915533 -2.2707 0.706751050630733 0.7067499346423969 -1.1228731862378272e-07 -0.09979850353692322 -2.2708000000000004 0.7067511580612355 0.7067500435160217 -1.1055615634428251e-07 -0.0997985646861469 -2.2709 0.7067512654777084 0.7067501523380662 -1.0880996189482905e-07 -0.09979862581683202 -2.271 0.7067513728803181 0.7067502611083839 -1.0704914236558255e-07 -0.09979868692898418 -2.2711 0.7067514802692265 0.7067503698268328 -1.0527410810364651e-07 -0.09979874802260896 -2.2712000000000003 0.7067515876445908 0.7067504784932751 -1.0348527259684132e-07 -0.09979880909771195 -2.2713 0.7067516950065642 0.7067505871075778 -1.0168305239824371e-07 -0.0997988701542988 -2.2714000000000003 0.706751802355295 0.7067506956696123 -9.986786701863398e-08 -0.09979893119237505 -2.2715 0.7067519096909272 0.7067508041792547 -9.804013883368823e-08 -0.09979899221194637 -2.2716 0.7067520170136001 0.7067509126363853 -9.620029298249705e-08 -0.09979905321301834 -2.2717 0.7067521243234485 0.7067510210408895 -9.434875726955366e-08 -0.09979911419559653 -2.2718000000000003 0.7067522316206023 0.7067511293926567 -9.248596205980314e-08 -0.09979917515968657 -2.2719 0.7067523389051873 0.7067512376915817 -9.06123401901715e-08 -0.09979923610529406 -2.272 0.706752446177324 0.706751345937563 -8.872832685941079e-08 -0.09979929703242457 -2.2721 0.7067525534371285 0.7067514541305046 -8.683435953355662e-08 -0.0997993579410837 -2.2722 0.7067526606847122 0.706751562270315 -8.493087783837533e-08 -0.09979941883127703 -2.2723 0.7067527679201816 0.7067516703569073 -8.301832346221949e-08 -0.09979947970301016 -2.2724 0.7067528751436385 0.7067517783901998 -8.109714005020974e-08 -0.09979954055628865 -2.2725 0.7067529823551799 0.7067518863701149 -7.916777310101875e-08 -0.0997996013911181 -2.2725999999999997 0.7067530895548981 0.7067519942965801 -7.723066987319616e-08 -0.09979966220750408 -2.2727000000000004 0.7067531967428806 0.7067521021695279 -7.528627926634002e-08 -0.09979972300545219 -2.2728 0.7067533039192098 0.7067522099888957 -7.333505172698804e-08 -0.09979978378496801 -2.2729 0.7067534110839634 0.7067523177546253 -7.137743914019737e-08 -0.0997998445460571 -2.273 0.7067535182372143 0.7067524254666638 -6.941389472936432e-08 -0.09979990528872504 -2.2731 0.7067536253790303 0.7067525331249631 -6.744487294650311e-08 -0.09979996601297743 -2.2732 0.7067537325094745 0.7067526407294795 -6.547082937293294e-08 -0.09980002671881978 -2.2733000000000003 0.706753839628605 0.7067527482801752 -6.349222060391888e-08 -0.09980008740625773 -2.2734 0.706753946736475 0.7067528557770164 -6.150950415629783e-08 -0.0998001480752968 -2.2735 0.7067540538331327 0.7067529632199744 -5.9523138349216326e-08 -0.09980020872594257 -2.2736 0.7067541609186216 0.7067530706090257 -5.753358220872071e-08 -0.0998002693582006 -2.2737000000000003 0.7067542679929801 0.7067531779441516 -5.554129535803587e-08 -0.09980032997207647 -2.2738 0.7067543750562417 0.7067532852253386 -5.354673790871137e-08 -0.09980039056757578 -2.2739000000000003 0.7067544821084348 0.7067533924525775 -5.155037035957377e-08 -0.099800451144704 -2.274 0.7067545891495832 0.7067534996258646 -4.9552653485162267e-08 -0.09980051170346678 -2.2741 0.7067546961797053 0.7067536067452009 -4.7554048234572585e-08 -0.09980057224386961 -2.2742000000000004 0.7067548031988147 0.7067537138105924 -4.555501562097681e-08 -0.09980063276591805 -2.2743 0.7067549102069204 0.7067538208220501 -4.355601661748575e-08 -0.09980069326961771 -2.2744 0.706755017204026 0.7067539277795898 -4.155751204985359e-08 -0.09980075375497408 -2.2745 0.7067551241901301 0.7067540346832324 -3.955996249208277e-08 -0.0998008142219927 -2.2746 0.7067552311652266 0.7067541415330039 -3.756382815727193e-08 -0.09980087467067913 -2.2747 0.7067553381293048 0.7067542483289344 -3.5569568794372765e-08 -0.09980093510103895 -2.2748000000000004 0.7067554450823484 0.7067543550710604 -3.3577643582900427e-08 -0.0998009955130777 -2.2749 0.7067555520243366 0.7067544617594219 -3.1588511021979e-08 -0.09980105590680088 -2.275 0.7067556589552435 0.7067545683940647 -2.9602628831299632e-08 -0.09980111628221411 -2.2751 0.7067557658750383 0.7067546749750389 -2.762045384248346e-08 -0.09980117663932286 -2.2752000000000003 0.7067558727836853 0.7067547815023999 -2.5642441895106644e-08 -0.09980123697813266 -2.2753 0.7067559796811442 0.706754887976208 -2.3669047730448534e-08 -0.09980129729864914 -2.2754000000000003 0.7067560865673697 0.706754994396528 -2.1700724887625117e-08 -0.09980135760087777 -2.2755 0.706756193442311 0.70675510076343 -1.9737925602975048e-08 -0.0998014178848241 -2.2756 0.7067563003059133 0.7067552070769885 -1.7781100697736307e-08 -0.09980147815049366 -2.2757 0.7067564071581166 0.7067553133372828 -1.583069948350377e-08 -0.09980153839789191 -2.2758000000000003 0.7067565139988563 0.7067554195443975 -1.3887169656411069e-08 -0.09980159862702445 -2.2759 0.7067566208280627 0.7067555256984218 -1.1950957189577754e-08 -0.0998016588378968 -2.276 0.7067567276456617 0.7067556317994496 -1.0022506237265805e-08 -0.09980171903051452 -2.2761 0.7067568344515742 0.7067557378475792 -8.102259030362546e-09 -0.09980177920488309 -2.2762000000000002 0.7067569412457164 0.706755843842914 -6.190655773598286e-09 -0.09980183936100803 -2.2763 0.7067570480279999 0.7067559497855626 -4.288134549702838e-09 -0.0998018994988949 -2.2764 0.7067571547983316 0.7067560556756369 -2.3951312079495413e-09 -0.09980195961854917 -2.2765 0.7067572615566133 0.7067561615132545 -5.120792826232567e-10 -0.09980201971997636 -2.2765999999999997 0.706757368302743 0.7067562672985375 1.3605901266755538e-09 -0.09980207980318201 -2.2767000000000004 0.7067574750366132 0.7067563730316124 3.222448437430192e-09 -0.0998021398681716 -2.2768 0.7067575817581129 0.7067564787126103 5.073069691760579e-09 -0.09980219991495067 -2.2769 0.7067576884671255 0.7067565843416668 6.912030654435131e-09 -0.0998022599435247 -2.277 0.7067577951635304 0.7067566899189223 8.738910900474295e-09 -0.09980231995389921 -2.2771 0.7067579018472028 0.7067567954445213 1.0553292918366597e-08 -0.09980237994607975 -2.2772 0.7067580085180125 0.706756900918613 1.2354762202876346e-08 -0.0998024399200718 -2.2773000000000003 0.7067581151758261 0.7067570063413509 1.4142907353055512e-08 -0.09980249987588084 -2.2774 0.7067582218205051 0.7067571117128926 1.5917320164184068e-08 -0.09980255981351241 -2.2775 0.7067583284519062 0.7067572170334007 1.76775957205777e-08 -0.09980261973297196 -2.2776 0.706758435069883 0.7067573223030414 1.9423332484058697e-08 -0.09980267963426503 -2.2777000000000003 0.7067585416742839 0.7067574275219859 2.1154132390233116e-08 -0.09980273951739711 -2.2778 0.7067586482649533 0.7067575326904089 2.2869600942165835e-08 -0.0998027993823737 -2.2779000000000003 0.7067587548417316 0.7067576378084895 2.4569347289310484e-08 -0.09980285922920025 -2.278 0.7067588614044547 0.7067577428764115 2.6252984331592844e-08 -0.09980291905788229 -2.2781 0.7067589679529547 0.7067578478943621 2.7920128795738686e-08 -0.0998029788684253 -2.2782000000000004 0.7067590744870595 0.7067579528625328 2.9570401327214113e-08 -0.0998030386608348 -2.2783 0.7067591810065934 0.706758057781119 3.120342657349229e-08 -0.09980309843511624 -2.2784 0.7067592875113757 0.7067581626503205 3.281883327425905e-08 -0.09980315819127511 -2.2785 0.7067593940012228 0.7067582674703405 3.441625433774076e-08 -0.09980321792931687 -2.2786 0.7067595004759464 0.7067583722413867 3.599532693611407e-08 -0.09980327764924705 -2.2787 0.7067596069353551 0.7067584769636699 3.7555692580099054e-08 -0.09980333735107114 -2.2788000000000004 0.7067597133792533 0.7067585816374051 3.909699719875648e-08 -0.09980339703479454 -2.2789 0.7067598198074415 0.7067586862628112 4.0618891226223974e-08 -0.09980345670042283 -2.279 0.7067599262197168 0.7067587908401107 4.2121029667635534e-08 -0.0998035163479614 -2.2791 0.7067600326158724 0.7067588953695293 4.360307219279658e-08 -0.09980357597741574 -2.2792000000000003 0.7067601389956983 0.7067589998512969 4.506468321251178e-08 -0.09980363558879136 -2.2793 0.7067602453589805 0.7067591042856467 4.650553194103513e-08 -0.09980369518209373 -2.2794 0.7067603517055017 0.706759208672815 4.792529247760191e-08 -0.09980375475732824 -2.2795 0.7067604580350413 0.7067593130130425 4.932364388796073e-08 -0.09980381431450047 -2.2796 0.7067605643473751 0.7067594173065723 5.070027026855828e-08 -0.09980387385361583 -2.2797 0.7067606706422758 0.7067595215536514 5.2054860814193527e-08 -0.0998039333746798 -2.2798000000000003 0.7067607769195123 0.7067596257545297 5.33871099030192e-08 -0.09980399287769781 -2.2799 0.7067608831788509 0.7067597299094605 5.4696717148583485e-08 -0.0998040523626753 -2.28 0.7067609894200542 0.7067598340187004 5.5983387472688384e-08 -0.09980411182961778 -2.2801 0.7067610956428825 0.7067599380825089 5.7246831181717583e-08 -0.09980417127853071 -2.2802000000000002 0.7067612018470919 0.7067600421011486 5.848676402388231e-08 -0.0998042307094195 -2.2803 0.7067613080324369 0.7067601460748851 5.970290724299776e-08 -0.09980429012228968 -2.2804 0.7067614141986676 0.7067602500039869 6.089498766868873e-08 -0.09980434951714662 -2.2805 0.7067615203455322 0.7067603538887253 6.206273774241045e-08 -0.0998044088939958 -2.2805999999999997 0.7067616264727759 0.7067604577293742 6.320589561112366e-08 -0.09980446825284266 -2.2807000000000004 0.706761732580141 0.7067605615262111 6.432420516025439e-08 -0.09980452759369267 -2.2808 0.7067618386673675 0.7067606652795152 6.541741607787865e-08 -0.0998045869165513 -2.2809 0.7067619447341924 0.7067607689895685 6.648528392584618e-08 -0.09980464622142393 -2.281 0.7067620507803501 0.7067608726566563 6.752757016927069e-08 -0.09980470550831605 -2.2811 0.7067621568055729 0.7067609762810653 6.85440422528577e-08 -0.0998047647772331 -2.2812 0.70676226280959 0.706761079863085 6.953447363733378e-08 -0.09980482402818046 -2.2813000000000003 0.7067623687921287 0.7067611834030079 7.049864385148819e-08 -0.09980488326116357 -2.2814 0.7067624747529144 0.7067612869011282 7.143633855288822e-08 -0.09980494247618793 -2.2815 0.7067625806916698 0.7067613903577421 7.234734957124733e-08 -0.099805001673259 -2.2816 0.7067626866081154 0.7067614937731486 7.323147493444593e-08 -0.09980506085238215 -2.2817000000000003 0.7067627925019695 0.7067615971476483 7.408851895179813e-08 -0.09980512001356283 -2.2818 0.7067628983729488 0.706761700481544 7.491829221058233e-08 -0.09980517915680648 -2.2819000000000003 0.7067630042207675 0.7067618037751402 7.572061165930788e-08 -0.09980523828211846 -2.282 0.7067631100451386 0.7067619070287436 7.649530063200127e-08 -0.09980529738950426 -2.2821 0.7067632158457728 0.7067620102426628 7.724218886902279e-08 -0.09980535647896932 -2.2822000000000005 0.7067633216223791 0.706762113417208 7.796111258819016e-08 -0.09980541555051903 -2.2823 0.7067634273746648 0.7067622165526908 7.865191449171749e-08 -0.09980547460415884 -2.2824 0.7067635331023359 0.7067623196494248 7.931444382519581e-08 -0.09980553363989414 -2.2825 0.7067636388050962 0.7067624227077247 7.994855637412368e-08 -0.09980559265773031 -2.2826 0.7067637444826489 0.7067625257279071 8.05541145489086e-08 -0.09980565165767286 -2.2827 0.7067638501346949 0.70676262871029 8.113098736578506e-08 -0.09980571063972714 -2.2828000000000004 0.7067639557609344 0.7067627316551924 8.167905050406044e-08 -0.09980576960389856 -2.2829 0.7067640613610664 0.7067628345629346 8.219818631999276e-08 -0.09980582855019254 -2.283 0.7067641669347882 0.7067629374338384 8.268828385372962e-08 -0.09980588747861448 -2.2831 0.7067642724817962 0.7067630402682266 8.314923890390125e-08 -0.09980594638916983 -2.2832000000000003 0.7067643780017862 0.7067631430664225 8.35809540015997e-08 -0.09980600528186398 -2.2833 0.7067644834944525 0.7067632458287509 8.398333845201222e-08 -0.09980606415670235 -2.2834 0.7067645889594887 0.7067633485555377 8.435630835350316e-08 -0.0998061230136903 -2.2835 0.7067646943965875 0.7067634512471088 8.469978659761401e-08 -0.09980618185283326 -2.2836 0.7067647998054408 0.7067635539037915 8.501370291069676e-08 -0.09980624067413657 -2.2837 0.7067649051857402 0.7067636565259139 8.529799385911807e-08 -0.09980629947760573 -2.2838000000000003 0.7067650105371762 0.706763759113804 8.555260284058563e-08 -0.09980635826324609 -2.2839 0.7067651158594392 0.7067638616677905 8.577748013445519e-08 -0.09980641703106302 -2.284 0.7067652211522191 0.7067639641882033 8.597258287570964e-08 -0.09980647578106196 -2.2841 0.706765326415205 0.7067640666753716 8.613787508444937e-08 -0.09980653451324827 -2.2842000000000002 0.7067654316480859 0.706764169129626 8.627332765374918e-08 -0.09980659322762736 -2.2843 0.7067655368505508 0.7067642715512967 8.63789183739444e-08 -0.09980665192420463 -2.2844 0.7067656420222885 0.7067643739407135 8.645463192222258e-08 -0.09980671060298543 -2.2845 0.7067657471629875 0.7067644762982073 8.650045986262345e-08 -0.09980676926397516 -2.2845999999999997 0.7067658522723362 0.7067645786241081 8.6516400658182e-08 -0.09980682790717917 -2.2847000000000004 0.7067659573500237 0.7067646809187469 8.650245965705072e-08 -0.09980688653260288 -2.2848 0.7067660623957386 0.7067647831824536 8.645864911331624e-08 -0.0998069451402517 -2.2849 0.7067661674091698 0.7067648854155583 8.638498814363127e-08 -0.09980700373013093 -2.285 0.7067662723900066 0.7067649876183908 8.628150275497015e-08 -0.09980706230224601 -2.2851 0.7067663773379388 0.7067650897912803 8.614822580646497e-08 -0.09980712085660227 -2.2852 0.7067664822526567 0.7067651919345559 8.598519702675278e-08 -0.09980717939320513 -2.2853000000000003 0.7067665871338507 0.7067652940485458 8.579246299142418e-08 -0.09980723791205993 -2.2854 0.7067666919812119 0.7067653961335781 8.557007709700248e-08 -0.09980729641317206 -2.2855 0.7067667967944323 0.7067654981899801 8.53180995748215e-08 -0.09980735489654691 -2.2856 0.7067669015732045 0.7067656002180778 8.503659744592273e-08 -0.09980741336218979 -2.2857000000000003 0.7067670063172218 0.7067657022181972 8.472564453493314e-08 -0.09980747181010612 -2.2858 0.7067671110261786 0.7067658041906627 8.438532143190125e-08 -0.09980753024030124 -2.2859000000000003 0.7067672156997699 0.7067659061357983 8.401571545760267e-08 -0.09980758865278049 -2.286 0.7067673203376921 0.7067660080539266 8.361692067221371e-08 -0.09980764704754928 -2.2861 0.7067674249396423 0.7067661099453696 8.318903782847387e-08 -0.09980770542461292 -2.2862000000000005 0.7067675295053191 0.7067662118104475 8.273217436474689e-08 -0.09980776378397681 -2.2863 0.7067676340344222 0.70676631364948 8.224644435471384e-08 -0.09980782212564632 -2.2864 0.7067677385266529 0.7067664154627844 8.173196850563835e-08 -0.09980788044962674 -2.2865 0.706767842981713 0.7067665172506779 8.118887409938602e-08 -0.09980793875592345 -2.2866 0.7067679473993067 0.7067666190134749 8.061729498722026e-08 -0.0998079970445418 -2.2867 0.7067680517791394 0.7067667207514898 8.001737154643418e-08 -0.09980805531548716 -2.2868000000000004 0.7067681561209179 0.7067668224650343 7.938925065432978e-08 -0.0998081135687649 -2.2869 0.7067682604243507 0.7067669241544188 7.873308563791093e-08 -0.0998081718043803 -2.287 0.7067683646891483 0.7067670258199517 7.804903623745418e-08 -0.09980823002233874 -2.2870999999999997 0.7067684689150227 0.7067671274619398 7.733726858742684e-08 -0.09980828822264556 -2.2872000000000003 0.7067685731016877 0.7067672290806882 7.659795514536327e-08 -0.09980834640530606 -2.2873 0.7067686772488595 0.7067673306765001 7.583127467278294e-08 -0.09980840457032568 -2.2874 0.7067687813562558 0.7067674322496763 7.503741218835291e-08 -0.09980846271770963 -2.2875 0.7067688854235963 0.7067675338005159 7.421655891758083e-08 -0.09980852084746333 -2.2876 0.7067689894506035 0.7067676353293157 7.336891225812048e-08 -0.09980857895959211 -2.2877 0.7067690934370017 0.7067677368363705 7.249467572773005e-08 -0.09980863705410131 -2.2878000000000003 0.7067691973825171 0.7067678383219723 7.159405890008741e-08 -0.09980869513099627 -2.2879 0.7067693012868788 0.7067679397864113 7.066727738744283e-08 -0.09980875319028226 -2.288 0.7067694051498177 0.7067680412299753 6.971455274173977e-08 -0.09980881123196467 -2.2881 0.7067695089710678 0.7067681426529493 6.873611245634959e-08 -0.09980886925604882 -2.2882000000000002 0.7067696127503653 0.7067682440556162 6.773218986198815e-08 -0.09980892726254004 -2.2883 0.7067697164874486 0.706768345438256 6.67030240972255e-08 -0.09980898525144358 -2.2884 0.7067698201820592 0.7067684468011457 6.564886006511783e-08 -0.09980904322276479 -2.2885 0.7067699238339415 0.7067685481445606 6.456994833953233e-08 -0.09980910117650904 -2.2885999999999997 0.706770027442842 0.7067686494687726 6.34665451373917e-08 -0.09980915911268161 -2.2887000000000004 0.7067701310085106 0.7067687507740508 6.233891224234622e-08 -0.09980921703128784 -2.2888 0.7067702345306999 0.7067688520606614 6.118731693711965e-08 -0.09980927493233305 -2.2889 0.7067703380091652 0.7067689533288679 6.001203195320215e-08 -0.09980933281582255 -2.289 0.7067704414436653 0.7067690545789307 5.8813335396257216e-08 -0.09980939068176164 -2.2891 0.7067705448339612 0.7067691558111067 5.759151068714108e-08 -0.09980944853015561 -2.2892 0.7067706481798178 0.7067692570256504 5.634684649424848e-08 -0.09980950636100983 -2.2893000000000003 0.7067707514810031 0.706769358222813 5.507963667626681e-08 -0.09980956417432957 -2.2894 0.7067708547372877 0.7067694594028417 5.3790180185031566e-08 -0.09980962197012011 -2.2895 0.7067709579484462 0.7067695605659814 5.247878101868886e-08 -0.09980967974838681 -2.2896 0.706771061114256 0.7067696617124736 5.1145748136693925e-08 -0.09980973750913497 -2.2897000000000003 0.7067711642344984 0.7067697628425555 4.9791395397361105e-08 -0.09980979525236988 -2.2898 0.7067712673089576 0.7067698639564619 4.841604147286238e-08 -0.09980985297809684 -2.2899000000000003 0.7067713703374214 0.7067699650544232 4.7020009790246786e-08 -0.09980991068632113 -2.29 0.7067714733196814 0.7067700661366672 4.560362844643895e-08 -0.09980996837704806 -2.2901 0.7067715762555321 0.7067701672034172 4.41672301197682e-08 -0.09981002605028283 -2.2902000000000005 0.7067716791447727 0.706770268254894 4.271115200925324e-08 -0.0998100837060309 -2.2903000000000002 0.7067717819872051 0.7067703692913134 4.1235735756539604e-08 -0.09981014134429744 -2.2904 0.7067718847826356 0.7067704703128885 3.9741327347020405e-08 -0.09981019896508783 -2.2905 0.706771987530874 0.7067705713198283 3.822827704565157e-08 -0.09981025656840731 -2.2906 0.7067720902317335 0.7067706723123379 3.669693930154205e-08 -0.09981031415426116 -2.2907 0.7067721928850318 0.7067707732906183 3.514767268376906e-08 -0.09981037172265467 -2.2908000000000004 0.7067722954905901 0.7067708742548673 3.358083978423354e-08 -0.09981042927359311 -2.2909 0.7067723980482339 0.7067709752052782 3.199680713092401e-08 -0.09981048680708182 -2.291 0.7067725005577923 0.7067710761420404 3.039594510811927e-08 -0.09981054432312605 -2.2910999999999997 0.7067726030190984 0.7067711770653394 2.8778627876591134e-08 -0.0998106018217311 -2.2912000000000003 0.70677270543199 0.7067712779753564 2.714523326084739e-08 -0.09981065930290219 -2.2913 0.7067728077963082 0.7067713788722688 2.5496142690151213e-08 -0.09981071676664464 -2.2914 0.7067729101118985 0.7067714797562498 2.3831741089233582e-08 -0.0998107742129637 -2.2915 0.7067730123786108 0.7067715806274679 2.2152416807169617e-08 -0.09981083164186465 -2.2916 0.706773114596299 0.7067716814860883 2.0458561514162532e-08 -0.09981088905335274 -2.2917 0.7067732167648215 0.7067717823322714 1.8750570101797037e-08 -0.09981094644743332 -2.2918000000000003 0.7067733188840404 0.7067718831661733 1.7028840612783036e-08 -0.0998110038241116 -2.2919 0.7067734209538226 0.7067719839879456 1.5293774131668048e-08 -0.0998110611833928 -2.292 0.7067735229740395 0.7067720847977363 1.3545774698101032e-08 -0.0998111185252823 -2.2921 0.7067736249445662 0.7067721855956883 1.1785249204483705e-08 -0.09981117584978524 -2.2922000000000002 0.7067737268652827 0.7067722863819403 1.0012607317907984e-08 -0.09981123315690693 -2.2923 0.7067738287360736 0.7067723871566267 8.22826137260313e-09 -0.09981129044665268 -2.2924 0.7067739305568275 0.7067724879198773 6.432626277995401e-09 -0.09981134771902771 -2.2925 0.7067740323274377 0.7067725886718175 4.626119418094099e-09 -0.09981140497403729 -2.2925999999999997 0.7067741340478019 0.7067726894125683 2.809160558683854e-09 -0.09981146221168663 -2.2927000000000004 0.7067742357178223 0.706772790142246 9.821717432412225e-10 -0.09981151943198106 -2.2928 0.7067743373374058 0.7067728908609621 -8.544227955362138e-10 -0.09981157663492575 -2.2929 0.7067744389064641 0.7067729915688237 -2.7001967363438073e-09 -0.09981163382052599 -2.293 0.7067745404249131 0.7067730922659337 -4.554721769883807e-09 -0.09981169098878706 -2.2931 0.7067746418926732 0.7067731929523897 -6.417567701214044e-09 -0.09981174813971416 -2.2932 0.70677474330967 0.7067732936282851 -8.288302550361892e-09 -0.09981180527331254 -2.2933000000000003 0.7067748446758335 0.7067733942937087 -1.0166492640795166e-08 -0.09981186238958747 -2.2934 0.7067749459910981 0.7067734949487443 -1.205170271434755e-08 -0.09981191948854418 -2.2935 0.7067750472554032 0.7067735955934709 -1.3943496026628394e-08 -0.09981197657018788 -2.2936 0.706775148468693 0.7067736962279634 -1.5841434443733537e-08 -0.09981203363452387 -2.2937000000000003 0.7067752496309159 0.7067737968522916 -1.774507854719609e-08 -0.09981209068155733 -2.2938 0.7067753507420256 0.7067738974665201 -1.9653987737202477e-08 -0.09981214771129351 -2.2939000000000003 0.7067754518019803 0.7067739980707098 -2.1567720331471668e-08 -0.0998122047237377 -2.294 0.7067755528107431 0.7067740986649161 -2.3485833672374362e-08 -0.0998122617188951 -2.2941 0.7067756537682814 0.7067741992491898 -2.5407884223643817e-08 -0.09981231869677093 -2.2942000000000005 0.7067757546745679 0.7067742998235769 -2.733342767532662e-08 -0.09981237565737039 -2.2943000000000002 0.7067758555295797 0.7067744003881187 -2.926201904699874e-08 -0.09981243260069877 -2.2944 0.7067759563332989 0.7067745009428515 -3.119321278881315e-08 -0.09981248952676125 -2.2945 0.7067760570857127 0.7067746014878074 -3.312656288601695e-08 -0.0998125464355631 -2.2946 0.7067761577868121 0.7067747020230126 -3.5061622961083186e-08 -0.09981260332710946 -2.2947 0.706776258436594 0.7067748025484897 -3.699794637898688e-08 -0.09981266020140567 -2.2948000000000004 0.7067763590350593 0.7067749030642557 -3.8935086345433766e-08 -0.09981271705845682 -2.2949 0.7067764595822144 0.7067750035703233 -4.087259601457576e-08 -0.09981277389826826 -2.295 0.7067765600780699 0.7067751040667001 -4.281002858913703e-08 -0.09981283072084512 -2.2950999999999997 0.7067766605226413 0.7067752045533887 -4.4746937424551634e-08 -0.09981288752619263 -2.2952000000000004 0.7067767609159494 0.7067753050303877 -4.668287613255901e-08 -0.09981294431431609 -2.2953 0.7067768612580191 0.7067754054976898 -4.861739868284795e-08 -0.09981300108522062 -2.2954 0.7067769615488803 0.7067755059552837 -5.055005950676053e-08 -0.0998130578389114 -2.2955 0.7067770617885678 0.7067756064031532 -5.2480413599695006e-08 -0.09981311457539371 -2.2956 0.7067771619771211 0.7067757068412774 -5.440801662155714e-08 -0.09981317129467278 -2.2957 0.7067772621145845 0.7067758072696301 -5.6332425002903613e-08 -0.0998132279967537 -2.2958000000000003 0.706777362201007 0.706775907688181 -5.825319604252019e-08 -0.09981328468164179 -2.2959 0.7067774622364423 0.7067760080968946 -6.016988801302303e-08 -0.09981334134934222 -2.296 0.7067775622209489 0.7067761084957309 -6.20820602595211e-08 -0.09981339799986017 -2.2961 0.7067776621545901 0.7067762088846452 -6.398927330326584e-08 -0.09981345463320083 -2.2962000000000002 0.7067777620374337 0.7067763092635881 -6.589108893966314e-08 -0.09981351124936948 -2.2963 0.7067778618695524 0.7067764096325053 -6.778707034322401e-08 -0.09981356784837124 -2.2964 0.7067779616510232 0.706776509991338 -6.967678216427547e-08 -0.09981362443021136 -2.2965 0.7067780613819283 0.7067766103400227 -7.155979063087556e-08 -0.09981368099489497 -2.2965999999999998 0.706778161062354 0.7067767106784912 -7.34356636459578e-08 -0.0998137375424273 -2.2967000000000004 0.7067782606923916 0.7067768110066706 -7.530397088751153e-08 -0.09981379407281352 -2.2968 0.7067783602721367 0.7067769113244836 -7.716428391309899e-08 -0.09981385058605882 -2.2969 0.7067784598016897 0.7067770116318487 -7.901617624268831e-08 -0.09981390708216846 -2.297 0.7067785592811556 0.7067771119286789 -8.085922347748215e-08 -0.09981396356114754 -2.2971 0.7067786587106436 0.7067772122148831 -8.269300337971491e-08 -0.09981402002300124 -2.2972 0.7067787580902678 0.7067773124903661 -8.451709597283308e-08 -0.09981407646773481 -2.2973000000000003 0.7067788574201462 0.7067774127550277 -8.633108364818065e-08 -0.09981413289535336 -2.2974 0.7067789567004021 0.7067775130087635 -8.813455124653119e-08 -0.09981418930586215 -2.2975 0.7067790559311624 0.7067776132514645 -8.992708616650802e-08 -0.09981424569926628 -2.2976 0.7067791551125591 0.7067777134830173 -9.170827844264678e-08 -0.09981430207557099 -2.2977000000000003 0.706779254244728 0.7067778137033045 -9.347772085468303e-08 -0.09981435843478143 -2.2978 0.7067793533278093 0.7067779139122039 -9.523500900734949e-08 -0.09981441477690274 -2.2979000000000003 0.7067794523619478 0.7067780141095892 -9.697974143879629e-08 -0.09981447110194012 -2.298 0.7067795513472928 0.7067781142953298 -9.871151969952086e-08 -0.09981452740989881 -2.2981 0.7067796502839969 0.7067782144692907 -1.004299484512472e-07 -0.09981458370078389 -2.2982000000000005 0.7067797491722174 0.7067783146313329 -1.0213463554065161e-07 -0.09981463997460048 -2.2983000000000002 0.7067798480121166 0.7067784147813133 -1.0382519211125235e-07 -0.09981469623135389 -2.2984 0.7067799468038594 0.7067785149190844 -1.0550123267453332e-07 -0.09981475247104914 -2.2985 0.7067800455476158 0.7067786150444948 -1.0716237521229272e-07 -0.0998148086936915 -2.2986 0.7067801442435597 0.706778715157389 -1.0880824125123617e-07 -0.0998148648992861 -2.2987 0.7067802428918689 0.7067788152576071 -1.104384559635907e-07 -0.09981492108783807 -2.2988000000000004 0.7067803414927254 0.7067789153449862 -1.1205264823128946e-07 -0.09981497725935264 -2.2989 0.7067804400463147 0.7067790154193582 -1.1365045073964686e-07 -0.09981503341383491 -2.299 0.7067805385528261 0.7067791154805521 -1.1523150007103355e-07 -0.09981508955129 -2.2990999999999997 0.7067806370124539 0.7067792155283925 -1.1679543678901061e-07 -0.09981514567172314 -2.2992000000000004 0.7067807354253948 0.7067793155627005 -1.1834190550598367e-07 -0.09981520177513946 -2.2993 0.70678083379185 0.7067794155832929 -1.1987055495779608e-07 -0.09981525786154405 -2.2994 0.7067809321120242 0.7067795155899836 -1.213810380991387e-07 -0.09981531393094215 -2.2995 0.7067810303861257 0.7067796155825825 -1.2287301217293878e-07 -0.09981536998333883 -2.2996 0.706781128614367 0.7067797155608951 -1.2434613881444345e-07 -0.09981542601873927 -2.2997 0.7067812267969635 0.7067798155247247 -1.2580008408417942e-07 -0.09981548203714861 -2.2998000000000003 0.7067813249341346 0.7067799154738699 -1.272345185737711e-07 -0.09981553803857203 -2.2999 0.7067814230261027 0.7067800154081265 -1.2864911747186014e-07 -0.09981559402301464 -2.3 0.7067815210730937 0.7067801153272867 -1.3004356064216793e-07 -0.09981564999048158 -2.3001 0.7067816190753373 0.7067802152311389 -1.3141753268074152e-07 -0.09981570594097795 -2.3002000000000002 0.7067817170330661 0.7067803151194687 -1.3277072300962867e-07 -0.09981576187450897 -2.3003 0.7067818149465165 0.7067804149920582 -1.3410282593585843e-07 -0.09981581779107968 -2.3004000000000002 0.7067819128159274 0.7067805148486865 -1.3541354071736067e-07 -0.09981587369069525 -2.3005 0.7067820106415412 0.7067806146891291 -1.36702571632355e-07 -0.09981592957336083 -2.3005999999999998 0.7067821084236037 0.7067807145131586 -1.3796962804006607e-07 -0.09981598543908153 -2.3007000000000004 0.7067822061623634 0.706780814320545 -1.3921442447266397e-07 -0.09981604128786248 -2.3008 0.7067823038580718 0.7067809141110544 -1.4043668066301973e-07 -0.09981609711970885 -2.3009 0.7067824015109838 0.7067810138844508 -1.416361216418499e-07 -0.09981615293462573 -2.301 0.7067824991213563 0.7067811136404948 -1.4281247776720685e-07 -0.09981620873261826 -2.3011 0.7067825966894499 0.7067812133789442 -1.4396548480254123e-07 -0.09981626451369155 -2.3012 0.7067826942155273 0.7067813130995539 -1.450948839895605e-07 -0.09981632027785067 -2.3013000000000003 0.7067827916998545 0.706781412802077 -1.462004220707802e-07 -0.09981637602510082 -2.3014 0.7067828891426996 0.7067815124862626 -1.472818513866686e-07 -0.09981643175544705 -2.3015 0.7067829865443338 0.7067816121518582 -1.4833892988952435e-07 -0.09981648746889454 -2.3016 0.7067830839050304 0.7067817117986084 -1.4937142123715164e-07 -0.09981654316544836 -2.3017000000000003 0.7067831812250656 0.7067818114262552 -1.503790948102074e-07 -0.09981659884511367 -2.3018 0.7067832785047174 0.7067819110345385 -1.5136172579199858e-07 -0.09981665450789552 -2.3019000000000003 0.706783375744267 0.7067820106231957 -1.5231909521185028e-07 -0.09981671015379906 -2.302 0.7067834729439966 0.7067821101919622 -1.532509899780654e-07 -0.09981676578282941 -2.3021 0.706783570104192 0.7067822097405705 -1.5415720294037483e-07 -0.09981682139499165 -2.3022000000000005 0.7067836672251402 0.7067823092687515 -1.5503753293504008e-07 -0.09981687699029089 -2.3023000000000002 0.7067837643071306 0.706782408776234 -1.5589178482822152e-07 -0.09981693256873224 -2.3024 0.7067838613504549 0.7067825082627448 -1.5671976955240752e-07 -0.09981698813032079 -2.3025 0.7067839583554063 0.7067826077280082 -1.5752130415498666e-07 -0.09981704367506167 -2.3026 0.7067840553222797 0.7067827071717472 -1.582962118260034e-07 -0.09981709920295995 -2.3027 0.7067841522513728 0.7067828065936825 -1.5904432196407747e-07 -0.09981715471402071 -2.3028000000000004 0.7067842491429841 0.706782905993534 -1.5976547019201648e-07 -0.09981721020824913 -2.3029 0.7067843459974139 0.7067830053710187 -1.6045949839671447e-07 -0.0998172656856502 -2.303 0.7067844428149648 0.7067831047258526 -1.6112625476905063e-07 -0.09981732114622904 -2.3030999999999997 0.7067845395959402 0.7067832040577501 -1.6176559382297118e-07 -0.09981737658999082 -2.3032000000000004 0.7067846363406451 0.7067833033664241 -1.6237737644232697e-07 -0.09981743201694054 -2.3033 0.7067847330493864 0.7067834026515862 -1.6296146991036375e-07 -0.09981748742708335 -2.3034 0.7067848297224717 0.706783501912946 -1.635177479565597e-07 -0.09981754282042427 -2.3035 0.7067849263602104 0.7067836011502131 -1.640460907149921e-07 -0.09981759819696845 -2.3036 0.706785022962913 0.7067837003630946 -1.6454638481974704e-07 -0.09981765355672095 -2.3037 0.7067851195308905 0.7067837995512969 -1.6501852340145007e-07 -0.0998177088996868 -2.3038000000000003 0.7067852160644561 0.7067838987145256 -1.6546240612716479e-07 -0.09981776422587119 -2.3039 0.7067853125639232 0.706783997852485 -1.6587793920733174e-07 -0.0998178195352791 -2.304 0.706785409029606 0.7067840969648788 -1.662650353940337e-07 -0.09981787482791563 -2.3041 0.7067855054618201 0.7067841960514094 -1.666236140347721e-07 -0.0998179301037859 -2.3042000000000002 0.7067856018608817 0.7067842951117789 -1.6695360107940593e-07 -0.09981798536289496 -2.3043 0.7067856982271075 0.7067843941456879 -1.672549291079073e-07 -0.09981804060524785 -2.3044000000000002 0.7067857945608149 0.7067844931528374 -1.6752753729913639e-07 -0.09981809583084968 -2.3045 0.7067858908623225 0.7067845921329273 -1.6777137148635268e-07 -0.09981815103970557 -2.3045999999999998 0.7067859871319482 0.7067846910856568 -1.679863841433371e-07 -0.09981820623182049 -2.3047000000000004 0.7067860833700113 0.7067847900107249 -1.681725344104129e-07 -0.09981826140719957 -2.3048 0.7067861795768309 0.7067848889078301 -1.6832978810832344e-07 -0.09981831656584782 -2.3049 0.7067862757527269 0.706784987776671 -1.6845811770874186e-07 -0.09981837170777036 -2.305 0.7067863718980191 0.7067850866169454 -1.6855750236376144e-07 -0.0998184268329722 -2.3051 0.7067864680130274 0.7067851854283516 -1.6862792790589554e-07 -0.09981848194145852 -2.3052 0.7067865640980716 0.7067852842105871 -1.6866938685848598e-07 -0.09981853703323422 -2.3053000000000003 0.7067866601534719 0.7067853829633501 -1.6868187842355997e-07 -0.09981859210830445 -2.3054 0.7067867561795482 0.7067854816863387 -1.686654084748912e-07 -0.09981864716667424 -2.3055 0.7067868521766205 0.7067855803792504 -1.686199895545304e-07 -0.09981870220834864 -2.3056 0.706786948145008 0.706785679041784 -1.685456408866831e-07 -0.09981875723333271 -2.3057000000000003 0.7067870440850302 0.7067857776736381 -1.6844238836036252e-07 -0.0998188122416315 -2.3058 0.7067871399970063 0.7067858762745118 -1.6831026453112408e-07 -0.09981886723325015 -2.3059000000000003 0.7067872358812542 0.7067859748441041 -1.6814930857249333e-07 -0.09981892220819355 -2.306 0.7067873317380923 0.706786073382115 -1.6795956630372144e-07 -0.09981897716646682 -2.3061 0.7067874275678379 0.7067861718882452 -1.6774109018284633e-07 -0.09981903210807505 -2.3062000000000005 0.7067875233708079 0.7067862703621957 -1.6749393927199818e-07 -0.09981908703302322 -2.3063000000000002 0.7067876191473179 0.7067863688036681 -1.6721817921658277e-07 -0.0998191419413164 -2.3064 0.7067877148976835 0.7067864672123652 -1.669138822314037e-07 -0.09981919683295962 -2.3065 0.706787810622219 0.7067865655879904 -1.6658112710933592e-07 -0.09981925170795791 -2.3066 0.7067879063212379 0.7067866639302482 -1.6621999915887586e-07 -0.09981930656631634 -2.3067 0.7067880019950525 0.706786762238844 -1.6583059023189684e-07 -0.09981936140803992 -2.3068 0.7067880976439744 0.7067868605134842 -1.6541299865079073e-07 -0.0998194162331337 -2.3069 0.706788193268314 0.7067869587538761 -1.649673292067333e-07 -0.09981947104160271 -2.307 0.7067882888683799 0.7067870569597288 -1.644936931458063e-07 -0.09981952583345197 -2.3070999999999997 0.7067883844444799 0.7067871551307523 -1.6399220812042536e-07 -0.09981958060868655 -2.3072000000000004 0.7067884799969208 0.7067872532666581 -1.6346299816852317e-07 -0.09981963536731145 -2.3073 0.7067885755260073 0.7067873513671588 -1.6290619367712034e-07 -0.09981969010933169 -2.3074 0.706788671032043 0.7067874494319686 -1.6232193136150874e-07 -0.09981974483475226 -2.3075 0.7067887665153301 0.7067875474608034 -1.6171035422535285e-07 -0.09981979954357827 -2.3076 0.7067888619761685 0.706787645453381 -1.6107161154160776e-07 -0.09981985423581471 -2.3077 0.7067889574148574 0.7067877434094203 -1.604058587761914e-07 -0.09981990891146661 -2.3078000000000003 0.7067890528316931 0.7067878413286419 -1.5971325758451504e-07 -0.09981996357053895 -2.3079 0.7067891482269713 0.7067879392107684 -1.5899397577331942e-07 -0.09982001821303675 -2.308 0.706789243600985 0.7067880370555246 -1.5824818723648992e-07 -0.09982007283896507 -2.3081 0.7067893389540254 0.706788134862637 -1.5747607193597468e-07 -0.09982012744832888 -2.3082000000000003 0.7067894342863821 0.706788232631834 -1.5667781584280394e-07 -0.09982018204113324 -2.3083 0.7067895295983418 0.7067883303628462 -1.558536108971914e-07 -0.09982023661738312 -2.3084000000000002 0.7067896248901903 0.706788428055406 -1.5500365496690094e-07 -0.09982029117708359 -2.3085 0.7067897201622098 0.7067885257092488 -1.541281518108173e-07 -0.09982034572023962 -2.3085999999999998 0.7067898154146812 0.7067886233241112 -1.532273109939447e-07 -0.09982040024685619 -2.3087000000000004 0.7067899106478825 0.7067887208997328 -1.5230134787005967e-07 -0.09982045475693835 -2.3088 0.7067900058620902 0.7067888184358556 -1.51350483524465e-07 -0.0998205092504911 -2.3089 0.706790101057577 0.7067889159322239 -1.5037494471500934e-07 -0.0998205637275194 -2.309 0.7067901962346144 0.7067890133885844 -1.4937496380790227e-07 -0.09982061818802833 -2.3091 0.7067902913934705 0.706789110804686 -1.4835077873781577e-07 -0.09982067263202278 -2.3092 0.706790386534411 0.7067892081802813 -1.4730263296798551e-07 -0.09982072705950785 -2.3093000000000004 0.7067904816576989 0.7067893055151249 -1.4623077539133167e-07 -0.09982078147048846 -2.3094 0.7067905767635951 0.7067894028089736 -1.4513546029923385e-07 -0.0998208358649697 -2.3095 0.7067906718523564 0.706789500061588 -1.440169473121422e-07 -0.09982089024295648 -2.3096 0.7067907669242379 0.7067895972727314 -1.4287550132580096e-07 -0.09982094460445384 -2.3097000000000003 0.7067908619794911 0.706789694442169 -1.4171139244532893e-07 -0.09982099894946672 -2.3098 0.7067909570183653 0.7067897915696703 -1.4052489590889172e-07 -0.09982105327800021 -2.3099000000000003 0.7067910520411057 0.7067898886550068 -1.3931629203565998e-07 -0.09982110759005919 -2.31 0.7067911470479551 0.7067899856979537 -1.380858661650941e-07 -0.0998211618856487 -2.3101 0.7067912420391531 0.7067900826982891 -1.368339085736775e-07 -0.0998212161647737 -2.3102000000000005 0.7067913370149361 0.706790179655794 -1.3556071442114015e-07 -0.0998212704274392 -2.3103000000000002 0.7067914319755375 0.7067902765702533 -1.342665836671919e-07 -0.09982132467365015 -2.3104 0.7067915269211866 0.7067903734414545 -1.3295182101774605e-07 -0.09982137890341154 -2.3105 0.7067916218521104 0.7067904702691887 -1.3161673582604005e-07 -0.0998214331167284 -2.3106 0.706791716768532 0.7067905670532505 -1.3026164206141055e-07 -0.09982148731360564 -2.3107 0.7067918116706708 0.7067906637934378 -1.2888685818959744e-07 -0.09982154149404826 -2.3108 0.7067919065587434 0.7067907604895519 -1.2749270713284522e-07 -0.09982159565806126 -2.3109 0.7067920014329625 0.7067908571413978 -1.2607951617969737e-07 -0.09982164980564957 -2.311 0.7067920962935371 0.7067909537487839 -1.246476169051991e-07 -0.09982170393681822 -2.3110999999999997 0.7067921911406729 0.7067910503115222 -1.2319734509977365e-07 -0.09982175805157217 -2.3112000000000004 0.7067922859745717 0.7067911468294286 -1.217290406807514e-07 -0.09982181214991633 -2.3113 0.7067923807954315 0.7067912433023222 -1.2024304764206295e-07 -0.09982186623185568 -2.3114 0.7067924756034467 0.7067913397300265 -1.1873971393107363e-07 -0.09982192029739523 -2.3115 0.7067925703988083 0.7067914361123684 -1.1721939139654192e-07 -0.0998219743465399 -2.3116 0.7067926651817028 0.7067915324491783 -1.1568243568974013e-07 -0.09982202837929466 -2.3117 0.7067927599523132 0.7067916287402912 -1.1412920620547384e-07 -0.0998220823956645 -2.3118000000000003 0.7067928547108187 0.7067917249855458 -1.1256006596759016e-07 -0.09982213639565438 -2.3119 0.7067929494573941 0.7067918211847841 -1.1097538156132347e-07 -0.09982219037926923 -2.312 0.7067930441922109 0.7067919173378527 -1.0937552304655929e-07 -0.09982224434651402 -2.3121 0.706793138915436 0.7067920134446022 -1.0776086387803696e-07 -0.09982229829739372 -2.3122000000000003 0.7067932336272322 0.706792109504887 -1.0613178080039892e-07 -0.09982235223191323 -2.3123 0.7067933283277588 0.7067922055185656 -1.0448865377359756e-07 -0.09982240615007754 -2.3124000000000002 0.7067934230171704 0.7067923014855009 -1.0283186587488335e-07 -0.09982246005189162 -2.3125 0.7067935176956177 0.7067923974055597 -1.0116180322421175e-07 -0.0998225139373604 -2.3125999999999998 0.7067936123632474 0.7067924932786129 -9.947885488102715e-08 -0.09982256780648883 -2.3127000000000004 0.7067937070202016 0.7067925891045361 -9.778341275579194e-08 -0.0998226216592819 -2.3128 0.7067938016666182 0.7067926848832085 -9.607587152238306e-08 -0.09982267549574443 -2.3129 0.7067938963026313 0.7067927806145137 -9.435662853395782e-08 -0.09982272931588149 -2.313 0.7067939909283699 0.70679287629834 -9.262608371193165e-08 -0.0998227831196979 -2.3131 0.7067940855439594 0.7067929719345798 -9.088463946010927e-08 -0.09982283690719872 -2.3132 0.7067941801495204 0.7067930675231298 -8.913270058402006e-08 -0.09982289067838884 -2.3133000000000004 0.7067942747451696 0.7067931630638911 -8.737067417989575e-08 -0.09982294443327322 -2.3134 0.7067943693310186 0.7067932585567691 -8.559896954880158e-08 -0.09982299817185675 -2.3135 0.7067944639071753 0.7067933540016739 -8.381799809688978e-08 -0.09982305189414438 -2.3136 0.7067945584737425 0.7067934493985195 -8.202817324692857e-08 -0.09982310560014107 -2.3137000000000003 0.7067946530308191 0.7067935447472251 -8.022991033595356e-08 -0.09982315928985173 -2.3138 0.7067947475784995 0.7067936400477138 -7.842362652245999e-08 -0.0998232129632813 -2.3139000000000003 0.7067948421168728 0.7067937352999134 -7.660974068318671e-08 -0.09982326662043473 -2.314 0.7067949366460242 0.7067938305037563 -7.478867332638e-08 -0.09982332026131685 -2.3141 0.7067950311660347 0.7067939256591792 -7.296084648640913e-08 -0.09982337388593267 -2.3142000000000005 0.7067951256769802 0.7067940207661236 -7.112668363182598e-08 -0.09982342749428715 -2.3143000000000002 0.7067952201789323 0.7067941158245357 -6.928660955824589e-08 -0.09982348108638517 -2.3144 0.7067953146719578 0.7067942108343653 -6.744105030161152e-08 -0.09982353466223164 -2.3145 0.7067954091561187 0.7067943057955681 -6.559043303237463e-08 -0.09982358822183142 -2.3146 0.706795503631473 0.7067944007081035 -6.373518595705063e-08 -0.09982364176518954 -2.3147 0.7067955980980738 0.7067944955719361 -6.187573821890557e-08 -0.09982369529231082 -2.3148 0.7067956925559696 0.7067945903870346 -6.001251980341377e-08 -0.09982374880320023 -2.3149 0.7067957870052042 0.7067946851533726 -5.814596143504172e-08 -0.0998238022978627 -2.315 0.7067958814458168 0.7067947798709285 -5.627649447750155e-08 -0.09982385577630311 -2.3150999999999997 0.7067959758778422 0.7067948745396848 -5.440455083226964e-08 -0.09982390923852638 -2.3152000000000004 0.7067960703013099 0.7067949691596291 -5.253056284512843e-08 -0.09982396268453742 -2.3153 0.7067961647162455 0.7067950637307534 -5.0654963202083e-08 -0.09982401611434111 -2.3154 0.7067962591226695 0.706795158253055 -4.8778184829289216e-08 -0.09982406952794243 -2.3155 0.7067963535205977 0.7067952527265344 -4.6900660792006076e-08 -0.09982412292534619 -2.3156 0.7067964479100417 0.7067953471511983 -4.50228241995654e-08 -0.09982417630655734 -2.3157 0.7067965422910083 0.7067954415270572 -4.3145108101396833e-08 -0.0998242296715808 -2.3158000000000003 0.7067966366634992 0.7067955358541264 -4.126794538898888e-08 -0.09982428302042146 -2.3159 0.7067967310275117 0.7067956301324259 -3.939176869400098e-08 -0.09982433635308416 -2.316 0.7067968253830389 0.7067957243619805 -3.751701029214901e-08 -0.0998243896695739 -2.3161 0.7067969197300685 0.706795818542819 -3.5644101999826594e-08 -0.0998244429698955 -2.3162000000000003 0.7067970140685841 0.7067959126749759 -3.3773475077367165e-08 -0.09982449625405386 -2.3163 0.7067971083985647 0.7067960067584894 -3.190556012878237e-08 -0.09982454952205393 -2.3164000000000002 0.7067972027199843 0.7067961007934025 -3.004078700250337e-08 -0.09982460277390054 -2.3165 0.7067972970328125 0.706796194779763 -2.8179584692826845e-08 -0.09982465600959857 -2.3165999999999998 0.7067973913370141 0.7067962887176231 -2.6322381240818926e-08 -0.09982470922915293 -2.3167000000000004 0.7067974856325501 0.7067963826070401 -2.4469603636737003e-08 -0.09982476243256856 -2.3168 0.7067975799193759 0.7067964764480752 -2.262167772115048e-08 -0.09982481561985032 -2.3169 0.7067976741974429 0.7067965702407945 -2.0779028089314144e-08 -0.09982486879100305 -2.317 0.7067977684666978 0.7067966639852684 -1.8942077989470008e-08 -0.0998249219460317 -2.3171 0.706797862727083 0.7067967576815719 -1.7111249226136466e-08 -0.09982497508494105 -2.3172 0.7067979569785358 0.7067968513297849 -1.5286962069469e-08 -0.09982502820773607 -2.3173000000000004 0.7067980512209895 0.7067969449299912 -1.3469635156380944e-08 -0.09982508131442157 -2.3174 0.706798145454373 0.7067970384822797 -1.1659685383424295e-08 -0.0998251344050025 -2.3175 0.7067982396786106 0.706797131986743 -9.85752782612509e-09 -0.09982518747948366 -2.3176 0.7067983338936219 0.7067972254434786 -8.063575638803111e-09 -0.09982524053786995 -2.3177000000000003 0.7067984280993225 0.7067973188525885 -6.27823995829474e-09 -0.09982529358016624 -2.3178 0.7067985222956233 0.7067974122141789 -4.501929809844207e-09 -0.09982534660637749 -2.3179000000000003 0.7067986164824311 0.7067975055283606 -2.7350520138622048e-09 -0.09982539961650848 -2.318 0.7067987106596483 0.7067975987952482 -9.780110983223511e-10 -0.09982545261056408 -2.3181 0.7067988048271725 0.7067976920149611 7.687908079243022e-10 -0.09982550558854919 -2.3182000000000005 0.7067988989848976 0.7067977851876228 2.5049540540791893e-09 -0.09982555855046861 -2.3183000000000002 0.7067989931327132 0.7067978783133609 4.230081561071297e-09 -0.0998256114963273 -2.3184 0.7067990872705043 0.7067979713923076 5.943778915232234e-09 -0.09982566442613003 -2.3185 0.706799181398152 0.706798064424599 7.64565445850185e-09 -0.09982571733988166 -2.3186 0.7067992755155332 0.7067981574103757 9.335319374297046e-09 -0.09982577023758717 -2.3187 0.7067993696225205 0.706798250349782 1.101238778118685e-08 -0.09982582311925131 -2.3188 0.7067994637189826 0.706798343242967 1.267647681529177e-08 -0.099825875984879 -2.3189 0.7067995578047839 0.7067984360900824 1.4327206729163044e-08 -0.09982592883447501 -2.319 0.7067996518797846 0.7067985288912855 1.5964200962906294e-08 -0.09982598166804423 -2.3190999999999997 0.7067997459438415 0.7067986216467371 1.7587086235254512e-08 -0.09982603448559152 -2.3192000000000004 0.7067998399968071 0.7067987143566018 1.9195492637243128e-08 -0.09982608728712172 -2.3193 0.7067999340385298 0.7067988070210482 2.078905370767048e-08 -0.09982614007263971 -2.3194 0.7068000280688542 0.706798899640249 2.2367406513762456e-08 -0.09982619284215032 -2.3195 0.7068001220876214 0.7067989922143801 2.393019174311284e-08 -0.09982624559565836 -2.3196 0.7068002160946681 0.7067990847436223 2.5477053789552118e-08 -0.09982629833316874 -2.3197 0.7068003100898279 0.706799177228159 2.7007640812995448e-08 -0.09982635105468628 -2.3198000000000003 0.7068004040729299 0.7067992696681779 2.8521604831382996e-08 -0.09982640376021579 -2.3199 0.7068004980438002 0.7067993620638706 3.001860181088556e-08 -0.09982645644976215 -2.32 0.7068005920022606 0.7067994544154321 3.149829172315044e-08 -0.09982650912333019 -2.3201 0.70680068594813 0.7067995467230607 3.2960338638976516e-08 -0.09982656178092472 -2.3202000000000003 0.7068007798812233 0.7067996389869589 3.440441079770318e-08 -0.09982661442255064 -2.3203 0.7068008738013516 0.7067997312073317 3.58301806939465e-08 -0.09982666704821269 -2.3204000000000002 0.7068009677083235 0.7067998233843888 3.7237325110558994e-08 -0.09982671965791573 -2.3205 0.7068010616019431 0.7067999155183426 3.8625525250468584e-08 -0.09982677225166463 -2.3205999999999998 0.706801155482012 0.7068000076094091 3.999446677484253e-08 -0.0998268248294642 -2.3207000000000004 0.7068012493483277 0.7068000996578073 4.134383987247636e-08 -0.09982687739131929 -2.3208 0.7068013432006852 0.7068001916637597 4.267333934306061e-08 -0.0998269299372347 -2.3209 0.7068014370388757 0.706800283627492 4.398266465789613e-08 -0.09982698246721526 -2.321 0.7068015308626874 0.7068003755492331 4.52715200344872e-08 -0.09982703498126581 -2.3211 0.7068016246719054 0.706800467429215 4.6539614497256854e-08 -0.09982708747939113 -2.3212 0.706801718466312 0.7068005592676727 4.778666194520109e-08 -0.09982713996159609 -2.3213000000000004 0.7068018122456861 0.706800651064844 4.9012381217808376e-08 -0.09982719242788549 -2.3214 0.7068019060098035 0.7068007428209702 5.0216496154040224e-08 -0.09982724487826411 -2.3215 0.7068019997584376 0.7068008345362953 5.139873565478126e-08 -0.09982729731273682 -2.3216 0.7068020934913588 0.7068009262110657 5.2558833753962864e-08 -0.09982734973130845 -2.3217000000000003 0.7068021872083347 0.7068010178455311 5.3696529668870174e-08 -0.09982740213398379 -2.3218 0.7068022809091297 0.7068011094399438 5.481156785565322e-08 -0.09982745452076762 -2.3219000000000003 0.706802374593506 0.7068012009945586 5.5903698082185316e-08 -0.09982750689166477 -2.322 0.7068024682612235 0.706801292509633 5.697267545408391e-08 -0.09982755924668008 -2.3221 0.7068025619120386 0.7068013839854272 5.801826051012038e-08 -0.0998276115858183 -2.3222000000000005 0.7068026555457061 0.7068014754222041 5.90402192499756e-08 -0.09982766390908429 -2.3223000000000003 0.7068027491619777 0.7068015668202281 6.003832318628166e-08 -0.09982771621648281 -2.3224 0.706802842760603 0.7068016581797671 6.101234939839828e-08 -0.0998277685080187 -2.3225 0.7068029363413293 0.7068017495010908 6.196208058098507e-08 -0.09982782078369672 -2.3226 0.7068030299039016 0.7068018407844713 6.288730511859464e-08 -0.09982787304352173 -2.3227 0.7068031234480627 0.7068019320301828 6.378781708914205e-08 -0.0998279252874985 -2.3228 0.706803216973553 0.7068020232385015 6.466341633329376e-08 -0.0998279775156318 -2.3229 0.7068033104801114 0.7068021144097061 6.551390850824401e-08 -0.09982802972792648 -2.323 0.7068034039674742 0.7068022055440768 6.633910510679686e-08 -0.09982808192438733 -2.3230999999999997 0.7068034974353763 0.7068022966418961 6.713882350246891e-08 -0.09982813410501909 -2.3232000000000004 0.7068035908835499 0.7068023877034483 6.79128870171436e-08 -0.09982818626982662 -2.3233 0.7068036843117264 0.7068024787290194 6.866112493668364e-08 -0.09982823841881466 -2.3234 0.7068037777196345 0.7068025697188971 6.93833725421561e-08 -0.099828290551988 -2.3235 0.7068038711070017 0.7068026606733715 7.007947116881297e-08 -0.09982834266935148 -2.3236 0.706803964473554 0.7068027515927333 7.074926824078565e-08 -0.09982839477090986 -2.3237 0.7068040578190153 0.7068028424772753 7.139261725373769e-08 -0.09982844685666786 -2.3238000000000003 0.7068041511431085 0.7068029333272918 7.200937787547879e-08 -0.09982849892663033 -2.3239 0.7068042444455548 0.7068030241430784 7.259941594596475e-08 -0.09982855098080204 -2.324 0.7068043377260742 0.7068031149249322 7.316260348770587e-08 -0.09982860301918778 -2.3241 0.7068044309843851 0.7068032056731514 7.36988187734211e-08 -0.09982865504179228 -2.3242000000000003 0.7068045242202052 0.7068032963880357 7.420794632430339e-08 -0.09982870704862042 -2.3243 0.7068046174332505 0.7068033870698858 7.468987694297935e-08 -0.0998287590396769 -2.3244000000000002 0.7068047106232364 0.7068034777190031 7.514450772391768e-08 -0.09982881101496648 -2.3245 0.7068048037898764 0.7068035683356909 7.557174210373607e-08 -0.09982886297449395 -2.3245999999999998 0.7068048969328843 0.7068036589202527 7.597148985773183e-08 -0.09982891491826411 -2.3247000000000004 0.7068049900519718 0.7068037494729933 7.634366712243323e-08 -0.09982896684628169 -2.3248 0.7068050831468509 0.706803839994218 7.668819642682456e-08 -0.09982901875855153 -2.3249 0.7068051762172318 0.7068039304842333 7.700500668714194e-08 -0.09982907065507833 -2.325 0.7068052692628244 0.7068040209433459 7.729403323636364e-08 -0.09982912253586684 -2.3251 0.7068053622833383 0.7068041113718635 7.755521783288366e-08 -0.09982917440092193 -2.3252 0.7068054552784826 0.7068042017700938 7.778850868479792e-08 -0.09982922625024826 -2.3253000000000004 0.7068055482479649 0.7068042921383455 7.79938604204139e-08 -0.0998292780838506 -2.3254 0.7068056411914936 0.7068043824769278 7.81712341350882e-08 -0.09982932990173372 -2.3255 0.7068057341087763 0.7068044727861498 7.832059740857378e-08 -0.09982938170390246 -2.3256 0.7068058269995201 0.7068045630663209 7.844192425124352e-08 -0.09982943349036147 -2.3257000000000003 0.7068059198634322 0.706804653317751 7.853519516654028e-08 -0.09982948526111557 -2.3258 0.7068060127002196 0.7068047435407498 7.860039713883382e-08 -0.09982953701616945 -2.3259000000000003 0.7068061055095891 0.7068048337356274 7.863752361433884e-08 -0.09982958875552791 -2.326 0.7068061982912477 0.7068049239026937 7.864657451325807e-08 -0.09982964047919571 -2.3261 0.7068062910449024 0.7068050140422585 7.862755624539475e-08 -0.0998296921871776 -2.3262000000000005 0.7068063837702605 0.7068051041546315 7.858048168066234e-08 -0.09982974387947832 -2.3263000000000003 0.706806476467029 0.7068051942401221 7.850537014214565e-08 -0.09982979555610261 -2.3264 0.7068065691349159 0.7068052842990393 7.840224743385638e-08 -0.09982984721705519 -2.3265 0.7068066617736292 0.7068053743316922 7.827114579042616e-08 -0.0998298988623409 -2.3266 0.7068067543828769 0.7068054643383891 7.811210390659684e-08 -0.09982995049196436 -2.3267 0.7068068469623683 0.7068055543194377 7.792516689558715e-08 -0.09983000210593035 -2.3268 0.7068069395118126 0.7068056442751456 7.771038628909266e-08 -0.09983005370424368 -2.3269 0.7068070320309201 0.7068057342058192 7.74678200147344e-08 -0.099830105286909 -2.327 0.7068071245194018 0.7068058241117645 7.719753241861027e-08 -0.0998301568539311 -2.3270999999999997 0.706807216976969 0.7068059139932872 7.689959419070191e-08 -0.09983020840531473 -2.3272000000000004 0.706807309403334 0.7068060038506907 7.657408238222196e-08 -0.09983025994106454 -2.3273 0.7068074017982104 0.7068060936842793 7.622108038653208e-08 -0.09983031146118533 -2.3274 0.7068074941613123 0.7068061834943551 7.584067789750959e-08 -0.09983036296568185 -2.3275 0.7068075864923552 0.7068062732812195 7.543297090260859e-08 -0.09983041445455877 -2.3276 0.7068076787910554 0.7068063630451729 7.499806166724743e-08 -0.09983046592782086 -2.3277 0.7068077710571306 0.7068064527865147 7.453605868450175e-08 -0.09983051738547288 -2.3278000000000003 0.7068078632902994 0.7068065425055425 7.404707667163501e-08 -0.09983056882751948 -2.3279 0.7068079554902822 0.7068066322025526 7.353123652846516e-08 -0.09983062025396539 -2.328 0.7068080476568004 0.7068067218778407 7.298866530613957e-08 -0.09983067166481535 -2.3281 0.7068081397895767 0.7068068115317003 7.241949617591004e-08 -0.0998307230600741 -2.3282000000000003 0.7068082318883362 0.706806901164424 7.182386842045918e-08 -0.09983077443974638 -2.3283 0.7068083239528045 0.7068069907763023 7.120192737491982e-08 -0.0998308258038369 -2.3284000000000002 0.706808415982709 0.7068070803676241 7.055382438177216e-08 -0.0998308771523503 -2.3285 0.7068085079777799 0.7068071699386769 6.987971678563965e-08 -0.0998309284852914 -2.3286 0.7068085999377476 0.7068072594897461 6.917976787430835e-08 -0.09983097980266485 -2.3287000000000004 0.7068086918623451 0.7068073490211157 6.845414683709361e-08 -0.09983103110447537 -2.3288 0.7068087837513074 0.7068074385330676 6.770302875269696e-08 -0.09983108239072772 -2.3289 0.7068088756043716 0.7068075280258814 6.692659451114358e-08 -0.0998311336614266 -2.329 0.7068089674212759 0.7068076174998351 6.612503076867948e-08 -0.09983118491657665 -2.3291 0.7068090592017613 0.7068077069552046 6.529852995817986e-08 -0.09983123615618264 -2.3292 0.706809150945571 0.7068077963922634 6.444729016771844e-08 -0.09983128738024923 -2.3293000000000004 0.7068092426524502 0.7068078858112831 6.357151514577164e-08 -0.09983133858878117 -2.3294 0.7068093343221462 0.7068079752125328 6.267141424744216e-08 -0.09983138978178313 -2.3295 0.7068094259544089 0.7068080645962795 6.174720234945752e-08 -0.09983144095925985 -2.3296 0.7068095175489904 0.7068081539627877 6.079909983455756e-08 -0.09983149212121599 -2.3297000000000003 0.7068096091056453 0.7068082433123195 5.982733252730965e-08 -0.09983154326765631 -2.3298 0.7068097006241303 0.7068083326451344 5.883213164206702e-08 -0.09983159439858545 -2.3299000000000003 0.7068097921042055 0.7068084219614893 5.7813733723988125e-08 -0.09983164551400807 -2.33 0.706809883545633 0.7068085112616387 5.677238059872969e-08 -0.09983169661392896 -2.3301 0.7068099749481773 0.7068086005458345 5.570831930305775e-08 -0.09983174769835274 -2.3302000000000005 0.7068100663116066 0.7068086898143257 5.462180203801015e-08 -0.09983179876728412 -2.3303000000000003 0.7068101576356909 0.7068087790673584 5.351308611685479e-08 -0.09983184982072785 -2.3304 0.7068102489202033 0.7068088683051763 5.238243388355768e-08 -0.09983190085868857 -2.3305 0.7068103401649197 0.7068089575280199 5.123011265206756e-08 -0.09983195188117093 -2.3306 0.7068104313696196 0.7068090467361267 5.005639467509093e-08 -0.09983200288817971 -2.3307 0.7068105225340846 0.7068091359297313 4.8861557033069714e-08 -0.09983205387971951 -2.3308 0.7068106136580996 0.7068092251090652 4.764588160816041e-08 -0.09983210485579501 -2.3309 0.7068107047414529 0.706809314274357 4.6409654999232663e-08 -0.09983215581641092 -2.331 0.7068107957839355 0.7068094034258321 4.515316844033723e-08 -0.09983220676157191 -2.3310999999999997 0.706810886785342 0.706809492563713 4.387671777468516e-08 -0.09983225769128272 -2.3312000000000004 0.7068109777454701 0.7068095816882184 4.2580603348829626e-08 -0.09983230860554801 -2.3313 0.7068110686641204 0.7068096707995637 4.126512994674647e-08 -0.09983235950437236 -2.3314 0.7068111595410974 0.7068097598979615 3.993060672738413e-08 -0.09983241038776054 -2.3315 0.7068112503762085 0.7068098489836205 3.857734714833583e-08 -0.09983246125571721 -2.3316 0.7068113411692647 0.7068099380567466 3.720566889471588e-08 -0.099832512108247 -2.3317 0.7068114319200807 0.7068100271175416 3.581589380803607e-08 -0.09983256294535459 -2.3318000000000003 0.7068115226284744 0.7068101161662044 3.4408347787326377e-08 -0.09983261376704472 -2.3319 0.7068116132942672 0.7068102052029297 3.2983360744032186e-08 -0.09983266457332202 -2.332 0.7068117039172841 0.7068102942279089 3.154126651874756e-08 -0.09983271536419108 -2.3321 0.706811794497354 0.7068103832413298 3.0082402773662364e-08 -0.09983276613965664 -2.3322000000000003 0.7068118850343093 0.7068104722433767 2.8607110957867832e-08 -0.09983281689972334 -2.3323 0.7068119755279862 0.7068105612342298 2.7115736184191164e-08 -0.09983286764439586 -2.3324000000000003 0.7068120659782244 0.7068106502140657 2.5608627182358012e-08 -0.09983291837367886 -2.3325 0.7068121563848677 0.7068107391830575 2.4086136207052133e-08 -0.09983296908757698 -2.3326 0.7068122467477638 0.7068108281413742 2.2548618947709764e-08 -0.09983301978609493 -2.3327000000000004 0.7068123370667634 0.7068109170891805 2.0996434447854984e-08 -0.09983307046923728 -2.3328 0.7068124273417224 0.7068110060266382 1.94299450305066e-08 -0.09983312113700876 -2.3329 0.7068125175724995 0.7068110949539044 1.7849516207972538e-08 -0.09983317178941403 -2.333 0.706812607758958 0.7068111838711324 1.625551658990948e-08 -0.09983322242645765 -2.3331 0.706812697900965 0.7068112727784717 1.4648317806995048e-08 -0.09983327304814436 -2.3332 0.7068127879983919 0.7068113616760674 1.3028294427661069e-08 -0.0998333236544788 -2.3333000000000004 0.7068128780511134 0.706811450564061 1.1395823848805997e-08 -0.09983337424546557 -2.3334 0.7068129680590088 0.7068115394425897 9.751286235079593e-09 -0.09983342482110935 -2.3335 0.706813058021962 0.7068116283117863 8.095064416534237e-09 -0.0998334753814148 -2.3336 0.70681314793986 0.70681171717178 6.427543800154034e-09 -0.09983352592638653 -2.3337000000000003 0.706813237812595 0.7068118060226953 4.749112284853363e-09 -0.0998335764560292 -2.3338 0.7068133276400625 0.7068118948646529 3.060160162597636e-09 -0.09983362697034745 -2.3339000000000003 0.7068134174221626 0.706811983697769 1.361080034269213e-09 -0.09983367746934589 -2.334 0.7068135071588 0.706812072522156 -3.4773327446668834e-10 -0.09983372795302924 -2.3341 0.7068135968498828 0.7068121613379212 -2.065882827653742e-09 -0.09983377842140202 -2.3342 0.7068136864953243 0.7068122501451686 -3.792969642361921e-09 -0.09983382887446897 -2.3343000000000003 0.7068137760950415 0.7068123389439971 -5.528592803179244e-09 -0.09983387931223464 -2.3344 0.7068138656489561 0.7068124277345015 -7.2723495472132305e-09 -0.09983392973470372 -2.3345 0.7068139551569939 0.7068125165167727 -9.023835353429155e-09 -0.09983398014188083 -2.3346 0.7068140446190851 0.7068126052908965 -1.0782644046733458e-08 -0.0998340305337706 -2.3347 0.7068141340351644 0.7068126940569548 -1.2548367885143602e-08 -0.09983408091037763 -2.3348 0.7068142234051706 0.7068127828150254 -1.4320597651294731e-08 -0.09983413127170664 -2.3349 0.7068143127290476 0.7068128715651805 -1.6098922753920997e-08 -0.09983418161776214 -2.335 0.7068144020067428 0.7068129603074892 -1.7882931321530626e-08 -0.09983423194854886 -2.3350999999999997 0.7068144912382086 0.7068130490420154 -1.9672210294779946e-08 -0.09983428226407132 -2.3352000000000004 0.7068145804234016 0.7068131377688186 -2.146634552491894e-08 -0.09983433256433417 -2.3353 0.7068146695622832 0.7068132264879543 -2.3264921867899996e-08 -0.0998343828493421 -2.3354 0.7068147586548189 0.706813315199473 -2.5067523280655063e-08 -0.09983443311909966 -2.3355 0.7068148477009788 0.7068134039034208 -2.6873732920842247e-08 -0.09983448337361146 -2.3356 0.7068149367007377 0.7068134925998397 -2.868313323575039e-08 -0.09983453361288214 -2.3357 0.7068150256540746 0.7068135812887668 -3.049530606638248e-08 -0.09983458383691633 -2.3358000000000003 0.7068151145609731 0.706813669970235 -3.230983274004652e-08 -0.09983463404571863 -2.3359 0.7068152034214212 0.7068137586442722 -3.4126294165765306e-08 -0.09983468423929363 -2.336 0.7068152922354114 0.7068138473109025 -3.5944270935866184e-08 -0.09983473441764594 -2.3361 0.7068153810029414 0.7068139359701449 -3.776334341857191e-08 -0.09983478458078023 -2.3362000000000003 0.706815469724012 0.7068140246220143 -3.958309185633779e-08 -0.09983483472870104 -2.3363 0.7068155583986298 0.7068141132665209 -4.140309646418882e-08 -0.09983488486141302 -2.3364000000000003 0.706815647026805 0.7068142019036701 -4.322293752193106e-08 -0.09983493497892076 -2.3365 0.7068157356085532 0.7068142905334633 -4.50421954756872e-08 -0.09983498508122884 -2.3366 0.7068158241438938 0.7068143791558975 -4.686045103216791e-08 -0.09983503516834191 -2.3367000000000004 0.7068159126328509 0.7068144677709645 -4.8677285257171625e-08 -0.09983508524026456 -2.3368 0.7068160010754532 0.7068145563786519 -5.049227966844646e-08 -0.09983513529700135 -2.3369 0.7068160894717336 0.706814644978943 -5.230501633700889e-08 -0.0998351853385569 -2.337 0.7068161778217297 0.7068147335718169 -5.411507798033094e-08 -0.09983523536493583 -2.3371 0.7068162661254834 0.7068148221572472 -5.5922048055852616e-08 -0.09983528537614265 -2.3372 0.7068163543830417 0.7068149107352041 -5.7725510863113755e-08 -0.09983533537218207 -2.3373000000000004 0.7068164425944551 0.706814999305653 -5.952505163515226e-08 -0.09983538535305862 -2.3374 0.706816530759779 0.7068150878685543 -6.132025663152865e-08 -0.09983543531877691 -2.3375 0.7068166188790733 0.7068151764238648 -6.31107132408916e-08 -0.0998354852693415 -2.3376 0.7068167069524021 0.7068152649715365 -6.489601006966564e-08 -0.09983553520475696 -2.3377000000000003 0.7068167949798344 0.7068153535115169 -6.667573703746099e-08 -0.09983558512502796 -2.3378 0.706816882961443 0.7068154420437496 -6.84494854733507e-08 -0.09983563503015906 -2.3379000000000003 0.7068169708973051 0.706815530568173 -7.021684820650992e-08 -0.09983568492015481 -2.338 0.7068170587875025 0.7068156190847219 -7.197741966292678e-08 -0.09983573479501978 -2.3381 0.7068171466321214 0.7068157075933263 -7.373079595821008e-08 -0.09983578465475865 -2.3382 0.706817234431252 0.7068157960939123 -7.547657498475913e-08 -0.0998358344993759 -2.3383000000000003 0.7068173221849889 0.7068158845864012 -7.721435651628084e-08 -0.09983588432887613 -2.3384 0.7068174098934312 0.7068159730707102 -7.894374228108181e-08 -0.09983593414326389 -2.3385 0.7068174975566819 0.7068160615467528 -8.066433607005485e-08 -0.09983598394254384 -2.3386 0.7068175851748487 0.7068161500144372 -8.237574381907836e-08 -0.09983603372672047 -2.3387000000000002 0.706817672748043 0.7068162384736683 -8.407757370442609e-08 -0.09983608349579838 -2.3388 0.7068177602763807 0.7068163269243466 -8.576943622603389e-08 -0.09983613324978219 -2.3389 0.7068178477599814 0.706816415366368 -8.745094429770534e-08 -0.09983618298867636 -2.339 0.7068179351989696 0.7068165037996248 -8.912171334078678e-08 -0.09983623271248557 -2.3390999999999997 0.7068180225934733 0.7068165922240053 -9.078136137003617e-08 -0.09983628242121435 -2.3392000000000004 0.7068181099436245 0.7068166806393931 -9.242950907775715e-08 -0.09983633211486725 -2.3393 0.7068181972495597 0.7068167690456684 -9.406577992400467e-08 -0.09983638179344888 -2.3394 0.7068182845114193 0.7068168574427067 -9.568980021551488e-08 -0.09983643145696376 -2.3395 0.7068183717293473 0.7068169458303806 -9.730119920371705e-08 -0.09983648110541649 -2.3396 0.7068184589034918 0.7068170342085572 -9.889960916192875e-08 -0.09983653073881157 -2.3397 0.7068185460340051 0.7068171225771012 -1.0048466546341839e-07 -0.09983658035715359 -2.3398000000000003 0.7068186331210429 0.7068172109358724 -1.0205600667594766e-07 -0.09983662996044712 -2.3399 0.7068187201647651 0.7068172992847275 -1.0361327463636466e-07 -0.09983667954869672 -2.34 0.7068188071653356 0.7068173876235188 -1.051561145356053e-07 -0.09983672912190694 -2.3401 0.7068188941229213 0.7068174759520949 -1.0668417500022537e-07 -0.09983677868008228 -2.3402000000000003 0.7068189810376936 0.7068175642703012 -1.0819710816612621e-07 -0.09983682822322737 -2.3403 0.7068190679098272 0.7068176525779788 -1.0969456976789305e-07 -0.09983687775134671 -2.3404000000000003 0.7068191547395003 0.7068177408749656 -1.1117621920644916e-07 -0.0998369272644449 -2.3405 0.7068192415268952 0.7068178291610954 -1.1264171963405734e-07 -0.09983697676252641 -2.3406 0.7068193282721975 0.7068179174361988 -1.1409073803411718e-07 -0.09983702624559587 -2.3407000000000004 0.7068194149755962 0.7068180057001028 -1.1552294527580886e-07 -0.09983707571365776 -2.3408 0.7068195016372841 0.7068180939526307 -1.1693801621817657e-07 -0.09983712516671665 -2.3409 0.7068195882574573 0.706818182193603 -1.1833562975870071e-07 -0.09983717460477715 -2.341 0.706819674836315 0.7068182704228361 -1.1971546892870777e-07 -0.0998372240278437 -2.3411 0.7068197613740601 0.706818358640143 -1.2107722095061613e-07 -0.09983727343592089 -2.3412 0.7068198478708986 0.7068184468453338 -1.2242057730212086e-07 -0.0998373228290132 -2.3413000000000004 0.7068199343270399 0.7068185350382153 -1.2374523380813407e-07 -0.09983737220712524 -2.3414 0.7068200207426967 0.7068186232185912 -1.2505089068415298e-07 -0.09983742157026153 -2.3415 0.7068201071180849 0.7068187113862615 -1.2633725262820028e-07 -0.09983747091842661 -2.3416 0.7068201934534226 0.7068187995410238 -1.2760402888153943e-07 -0.099837520251625 -2.3417000000000003 0.7068202797489324 0.7068188876826718 -1.2885093327030805e-07 -0.09983756956986119 -2.3418 0.7068203660048389 0.7068189758109968 -1.3007768430960132e-07 -0.09983761887313977 -2.3419 0.70682045222137 0.7068190639257872 -1.3128400522428862e-07 -0.09983766816146526 -2.342 0.7068205383987569 0.7068191520268279 -1.324696240513623e-07 -0.09983771743484221 -2.3421 0.7068206245372325 0.7068192401139015 -1.3363427367983627e-07 -0.09983776669327507 -2.3422 0.7068207106370338 0.7068193281867874 -1.3477769190452238e-07 -0.0998378159367684 -2.3423000000000003 0.7068207966983997 0.7068194162452623 -1.3589962150756252e-07 -0.09983786516532672 -2.3424 0.7068208827215725 0.7068195042891008 -1.3699981030006192e-07 -0.0998379143789546 -2.3425 0.7068209687067966 0.706819592318074 -1.3807801117760032e-07 -0.09983796357765652 -2.3426 0.7068210546543188 0.7068196803319508 -1.3913398218962092e-07 -0.099838012761437 -2.3427000000000002 0.7068211405643889 0.7068197683304975 -1.401674865741248e-07 -0.09983806193030054 -2.3428 0.7068212264372593 0.7068198563134782 -1.411782928235905e-07 -0.09983811108425171 -2.3429 0.7068213122731843 0.7068199442806541 -1.421661747335462e-07 -0.09983816022329496 -2.343 0.7068213980724212 0.7068200322317844 -1.431309114528767e-07 -0.09983820934743488 -2.3430999999999997 0.7068214838352285 0.7068201201666259 -1.4407228754800827e-07 -0.09983825845667593 -2.3432000000000004 0.7068215695618683 0.7068202080849326 -1.4499009301852106e-07 -0.09983830755102258 -2.3433 0.7068216552526039 0.7068202959864576 -1.45884123373477e-07 -0.09983835663047941 -2.3434 0.7068217409077013 0.7068203838709507 -1.467541796539712e-07 -0.09983840569505095 -2.3435 0.7068218265274282 0.7068204717381602 -1.476000685007861e-07 -0.09983845474474168 -2.3436 0.7068219121120545 0.7068205595878319 -1.4842160219429024e-07 -0.09983850377955605 -2.3437 0.7068219976618517 0.7068206474197103 -1.4921859865270337e-07 -0.0998385527994986 -2.3438000000000003 0.7068220831770938 0.7068207352335374 -1.4999088154138418e-07 -0.09983860180457388 -2.3439 0.7068221686580565 0.706820823029054 -1.5073828025548297e-07 -0.09983865079478636 -2.344 0.7068222541050164 0.7068209108059985 -1.5146062999973897e-07 -0.09983869977014051 -2.3441 0.7068223395182527 0.7068209985641081 -1.5215777179021506e-07 -0.09983874873064084 -2.3442000000000003 0.7068224248980463 0.7068210863031179 -1.5282955249766583e-07 -0.09983879767629188 -2.3443 0.706822510244679 0.7068211740227621 -1.534758249117224e-07 -0.09983884660709813 -2.3444000000000003 0.7068225955584344 0.7068212617227725 -1.5409644771487152e-07 -0.09983889552306402 -2.3445 0.706822680839598 0.7068213494028802 -1.5469128556919176e-07 -0.09983894442419414 -2.3446 0.7068227660884558 0.7068214370628146 -1.5526020911982297e-07 -0.09983899331049292 -2.3447000000000005 0.7068228513052959 0.7068215247023039 -1.558030950209871e-07 -0.09983904218196483 -2.3448 0.7068229364904072 0.7068216123210748 -1.563198259758869e-07 -0.09983909103861445 -2.3449 0.7068230216440796 0.7068216999188529 -1.5681029074364472e-07 -0.09983913988044615 -2.345 0.7068231067666049 0.7068217874953632 -1.5727438418093598e-07 -0.09983918870746449 -2.3451 0.706823191858275 0.706821875050329 -1.5771200725586687e-07 -0.09983923751967394 -2.3452 0.7068232769193837 0.7068219625834726 -1.5812306707052581e-07 -0.09983928631707899 -2.3453000000000004 0.7068233619502251 0.7068220500945159 -1.5850747686965705e-07 -0.0998393350996841 -2.3454 0.7068234469510943 0.7068221375831795 -1.58865156082294e-07 -0.09983938386749379 -2.3455 0.7068235319222872 0.7068222250491834 -1.5919603032349405e-07 -0.0998394326205125 -2.3456 0.7068236168641004 0.7068223124922468 -1.5950003140127733e-07 -0.09983948135874471 -2.3457000000000003 0.7068237017768313 0.7068223999120882 -1.5977709735826018e-07 -0.09983953008219495 -2.3458 0.7068237866607777 0.7068224873084258 -1.6002717243869535e-07 -0.09983957879086763 -2.3459 0.706823871516238 0.7068225746809771 -1.602502071595957e-07 -0.09983962748476732 -2.346 0.706823956343511 0.7068226620294586 -1.604461582691008e-07 -0.09983967616389838 -2.3461 0.706824041142896 0.7068227493535875 -1.6061498877596725e-07 -0.09983972482826535 -2.3462 0.7068241259146923 0.7068228366530797 -1.6075666795477284e-07 -0.09983977347787265 -2.3463000000000003 0.7068242106592002 0.7068229239276513 -1.608711713424471e-07 -0.0998398221127248 -2.3464 0.7068242953767193 0.706823011177018 -1.6095848076602692e-07 -0.09983987073282624 -2.3465 0.7068243800675498 0.7068230984008959 -1.6101858430969673e-07 -0.09983991933818143 -2.3466 0.7068244647319919 0.7068231855990006 -1.6105147635295247e-07 -0.0998399679287949 -2.3467000000000002 0.7068245493703454 0.7068232727710477 -1.61057157542846e-07 -0.09984001650467106 -2.3468 0.7068246339829107 0.7068233599167528 -1.6103563479051564e-07 -0.09984006506581435 -2.3469 0.7068247185699874 0.7068234470358319 -1.6098692129026815e-07 -0.09984011361222923 -2.347 0.7068248031318753 0.7068235341280014 -1.6091103650049676e-07 -0.09984016214392023 -2.3470999999999997 0.7068248876688741 0.7068236211929775 -1.608080061367423e-07 -0.09984021066089177 -2.3472000000000004 0.706824972181282 0.7068237082304771 -1.6067786216128477e-07 -0.09984025916314831 -2.3473 0.7068250566693983 0.7068237952402173 -1.605206427848782e-07 -0.0998403076506943 -2.3474 0.7068251411335208 0.7068238822219158 -1.6033639245113807e-07 -0.0998403561235342 -2.3475 0.7068252255739469 0.7068239691752908 -1.6012516181398984e-07 -0.0998404045816724 -2.3476 0.7068253099909738 0.706824056100061 -1.5988700775154685e-07 -0.09984045302511345 -2.3477 0.7068253943848978 0.7068241429959463 -1.5962199330366023e-07 -0.09984050145386177 -2.3478000000000003 0.7068254787560141 0.7068242298626666 -1.5933018771355223e-07 -0.09984054986792179 -2.3479 0.7068255631046173 0.7068243166999433 -1.5901166636189679e-07 -0.09984059826729796 -2.348 0.7068256474310014 0.7068244035074982 -1.5866651077896254e-07 -0.09984064665199471 -2.3481 0.7068257317354592 0.7068244902850543 -1.5829480860471423e-07 -0.09984069502201656 -2.3482000000000003 0.7068258160182823 0.7068245770323356 -1.578966535766696e-07 -0.09984074337736787 -2.3483 0.7068259002797617 0.7068246637490672 -1.574721454986744e-07 -0.09984079171805316 -2.3484000000000003 0.7068259845201864 0.7068247504349751 -1.5702139022182038e-07 -0.09984084004407677 -2.3485 0.7068260687398452 0.7068248370897867 -1.5654449962709815e-07 -0.09984088835544323 -2.3486 0.7068261529390252 0.7068249237132307 -1.560415915733554e-07 -0.09984093665215693 -2.3487000000000005 0.7068262371180118 0.7068250103050369 -1.55512789890358e-07 -0.09984098493422232 -2.3488 0.7068263212770897 0.706825096864937 -1.5495822434929973e-07 -0.09984103320164384 -2.3489 0.7068264054165413 0.7068251833926638 -1.543780306107606e-07 -0.09984108145442593 -2.349 0.7068264895366483 0.7068252698879517 -1.5377235020042068e-07 -0.09984112969257301 -2.3491 0.7068265736376902 0.7068253563505364 -1.5314133048303924e-07 -0.09984117791608951 -2.3492 0.7068266577199452 0.7068254427801558 -1.524851246346992e-07 -0.09984122612497988 -2.3493000000000004 0.7068267417836896 0.7068255291765492 -1.5180389157515295e-07 -0.09984127431924855 -2.3494 0.706826825829198 0.7068256155394574 -1.510977959487403e-07 -0.09984132249889989 -2.3495 0.7068269098567429 0.7068257018686238 -1.503670080931635e-07 -0.09984137066393839 -2.3495999999999997 0.7068269938665954 0.7068257881637932 -1.4961170397530255e-07 -0.09984141881436848 -2.3497000000000003 0.7068270778590242 0.7068258744247121 -1.4883206518254144e-07 -0.09984146695019451 -2.3498 0.7068271618342961 0.7068259606511296 -1.4802827882735847e-07 -0.09984151507142099 -2.3499 0.706827245792676 0.7068260468427965 -1.4720053755946927e-07 -0.09984156317805229 -2.35 0.7068273297344264 0.706826132999466 -1.4634903948082534e-07 -0.09984161127009286 -2.3501 0.7068274136598078 0.7068262191208928 -1.4547398812306267e-07 -0.09984165934754707 -2.3502 0.7068274975690783 0.7068263052068349 -1.4457559237464335e-07 -0.09984170741041937 -2.3503000000000003 0.706827581462494 0.7068263912570519 -1.4365406644616108e-07 -0.09984175545871421 -2.3504 0.706827665340308 0.7068264772713062 -1.4270962982350366e-07 -0.09984180349243596 -2.3505 0.7068277492027715 0.7068265632493619 -1.417425072036682e-07 -0.09984185151158902 -2.3506 0.7068278330501332 0.7068266491909863 -1.407529284513931e-07 -0.09984189951617782 -2.3507000000000002 0.7068279168826389 0.7068267350959488 -1.3974112853150367e-07 -0.09984194750620676 -2.3508 0.7068280007005322 0.7068268209640219 -1.3870734747074842e-07 -0.09984199548168027 -2.3509 0.7068280845040542 0.7068269067949804 -1.3765183028494055e-07 -0.0998420434426028 -2.351 0.7068281682934425 0.706826992588601 -1.3657482693558987e-07 -0.09984209138897862 -2.3510999999999997 0.7068282520689328 0.7068270783446647 -1.35476592253575e-07 -0.09984213932081226 -2.3512000000000004 0.7068283358307579 0.7068271640629544 -1.3435738588710167e-07 -0.09984218723810809 -2.3513 0.706828419579147 0.7068272497432558 -1.3321747225486513e-07 -0.09984223514087051 -2.3514 0.7068285033143273 0.7068273353853578 -1.320571204558446e-07 -0.09984228302910392 -2.3515 0.7068285870365224 0.7068274209890519 -1.3087660424154768e-07 -0.09984233090281269 -2.3516 0.7068286707459533 0.7068275065541328 -1.2967620190325324e-07 -0.09984237876200125 -2.3517 0.706828754442838 0.7068275920803986 -1.2845619625119487e-07 -0.09984242660667399 -2.3518000000000003 0.7068288381273911 0.7068276775676496 -1.272168745208857e-07 -0.09984247443683533 -2.3519 0.7068289217998244 0.7068277630156902 -1.2595852831934207e-07 -0.09984252225248963 -2.352 0.7068290054603459 0.7068278484243272 -1.2468145355395976e-07 -0.09984257005364129 -2.3521 0.7068290891091611 0.7068279337933714 -1.2338595035965572e-07 -0.09984261784029472 -2.3522000000000003 0.7068291727464717 0.7068280191226362 -1.220723230277443e-07 -0.0998426656124543 -2.3523 0.7068292563724765 0.7068281044119384 -1.2074087994348726e-07 -0.09984271337012446 -2.3524000000000003 0.7068293399873704 0.7068281896610984 -1.1939193349935762e-07 -0.09984276111330948 -2.3525 0.7068294235913457 0.7068282748699402 -1.1802580002912011e-07 -0.09984280884201384 -2.3526 0.7068295071845903 0.7068283600382905 -1.16642799740177e-07 -0.09984285655624188 -2.3527000000000005 0.7068295907672892 0.7068284451659805 -1.1524325662509716e-07 -0.099842904255998 -2.3528000000000002 0.7068296743396236 0.7068285302528439 -1.1382749840437023e-07 -0.09984295194128655 -2.3529 0.7068297579017717 0.7068286152987187 -1.1239585642405792e-07 -0.09984299961211197 -2.353 0.7068298414539071 0.7068287003034461 -1.1094866560201755e-07 -0.09984304726847859 -2.3531 0.706829924996201 0.7068287852668713 -1.0948626433596176e-07 -0.09984309491039084 -2.3532 0.7068300085288199 0.7068288701888428 -1.0800899442539591e-07 -0.09984314253785309 -2.3533000000000004 0.7068300920519268 0.7068289550692128 -1.0651720100916806e-07 -0.09984319015086968 -2.3534 0.7068301755656814 0.7068290399078377 -1.0501123245618138e-07 -0.09984323774944501 -2.3535 0.7068302590702392 0.7068291247045773 -1.0349144030554619e-07 -0.09984328533358346 -2.3535999999999997 0.7068303425657518 0.7068292094592951 -1.0195817917463962e-07 -0.09984333290328934 -2.3537000000000003 0.7068304260523672 0.7068292941718588 -1.0041180668191041e-07 -0.09984338045856711 -2.3538 0.7068305095302296 0.7068293788421397 -9.88526833566733e-08 -0.09984342799942104 -2.3539 0.7068305929994791 0.7068294634700132 -9.728117256711799e-08 -0.0998434755258556 -2.354 0.7068306764602519 0.7068295480553586 -9.569764041709311e-08 -0.0998435230378751 -2.3541 0.7068307599126803 0.7068296325980588 -9.410245568365616e-08 -0.09984357053548387 -2.3542 0.7068308433568926 0.7068297170980012 -9.249598971038803e-08 -0.09984361801868635 -2.3543000000000003 0.706830926793013 0.7068298015550774 -9.08786163319325e-08 -0.0998436654874869 -2.3544 0.7068310102211615 0.7068298859691817 -8.925071178726013e-08 -0.09984371294188982 -2.3545 0.7068310936414546 0.7068299703402143 -8.761265462946255e-08 -0.09984376038189952 -2.3546 0.7068311770540039 0.7068300546680784 -8.596482563728164e-08 -0.09984380780752034 -2.3547000000000002 0.7068312604589175 0.7068301389526812 -8.430760772490387e-08 -0.0998438552187566 -2.3548 0.7068313438562994 0.7068302231939348 -8.264138586303038e-08 -0.09984390261561277 -2.3549 0.7068314272462488 0.7068303073917548 -8.096654697392625e-08 -0.09984394999809304 -2.355 0.7068315106288614 0.7068303915460612 -7.928347985595996e-08 -0.09984399736620193 -2.3550999999999997 0.706831594004228 0.7068304756567781 -7.759257508385686e-08 -0.09984404471994367 -2.3552000000000004 0.7068316773724362 0.706830559723834 -7.589422492543241e-08 -0.09984409205932267 -2.3553 0.7068317607335685 0.7068306437471616 -7.41888232409782e-08 -0.09984413938434328 -2.3554 0.7068318440877033 0.7068307277266976 -7.247676540259734e-08 -0.09984418669500977 -2.3555 0.7068319274349149 0.7068308116623834 -7.075844819315683e-08 -0.0998442339913266 -2.3556 0.7068320107752735 0.7068308955541643 -6.903426972388813e-08 -0.09984428127329811 -2.3557 0.7068320941088446 0.70683097940199 -6.730462933464063e-08 -0.09984432854092858 -2.3558000000000003 0.7068321774356896 0.7068310632058146 -6.556992750454335e-08 -0.0998443757942224 -2.3559 0.7068322607558652 0.706831146965596 -6.383056575789622e-08 -0.0998444230331838 -2.356 0.7068323440694249 0.7068312306812972 -6.208694657353075e-08 -0.09984447025781724 -2.3561 0.7068324273764164 0.7068313143528853 -6.033947328983394e-08 -0.09984451746812706 -2.3562000000000003 0.706832510676884 0.7068313979803311 -5.8588550009338464e-08 -0.09984456466411751 -2.3563 0.7068325939708675 0.7068314815636108 -5.6834581513287574e-08 -0.09984461184579302 -2.3564000000000003 0.706832677258402 0.706831565102704 -5.507797315863587e-08 -0.09984465901315784 -2.3565 0.706832760539519 0.7068316485975953 -5.331913079152997e-08 -0.09984470616621638 -2.3566 0.7068328438142446 0.7068317320482732 -5.155846064561036e-08 -0.09984475330497294 -2.3567000000000005 0.7068329270826013 0.7068318154547311 -4.979636925852779e-08 -0.09984480042943183 -2.3568000000000002 0.7068330103446068 0.706831898816966 -4.80332633699199e-08 -0.09984484753959738 -2.3569 0.7068330936002749 0.7068319821349802 -4.6269549832777656e-08 -0.099844894635474 -2.357 0.7068331768496146 0.7068320654087796 -4.450563551375297e-08 -0.09984494171706594 -2.3571 0.7068332600926304 0.7068321486383751 -4.2741927205284126e-08 -0.09984498878437756 -2.3572 0.706833343329323 0.706832231823781 -4.097883152969807e-08 -0.09984503583741314 -2.3573000000000004 0.7068334265596885 0.7068323149650173 -3.92167548435296e-08 -0.09984508287617705 -2.3574 0.7068335097837182 0.706832398062107 -3.745610314704467e-08 -0.09984512990067357 -2.3575 0.7068335930013998 0.7068324811150781 -3.569728198736695e-08 -0.09984517691090705 -2.3575999999999997 0.7068336762127161 0.7068325641239634 -3.3940696369302165e-08 -0.09984522390688179 -2.3577000000000004 0.7068337594176457 0.7068326470887996 -3.218675065754309e-08 -0.09984527088860215 -2.3578 0.7068338426161629 0.7068327300096271 -3.0435848487331274e-08 -0.09984531785607241 -2.3579 0.7068339258082378 0.7068328128864916 -2.8688392670348298e-08 -0.0998453648092969 -2.358 0.7068340089938356 0.706832895719443 -2.694478509930598e-08 -0.09984541174827993 -2.3581 0.7068340921729183 0.7068329785085348 -2.5205426662511243e-08 -0.0998454586730258 -2.3582 0.7068341753454425 0.7068330612538253 -2.347071714281848e-08 -0.09984550558353886 -2.3583000000000003 0.706834258511361 0.706833143955377 -2.17410551337123e-08 -0.09984555247982334 -2.3584 0.7068343416706222 0.7068332266132571 -2.001683794194617e-08 -0.09984559936188367 -2.3585 0.7068344248231707 0.7068333092275358 -1.829846149863784e-08 -0.09984564622972406 -2.3586 0.7068345079689462 0.7068333917982891 -1.6586320270798455e-08 -0.09984569308334884 -2.3587000000000002 0.7068345911078844 0.706833474325596 -1.488080716895851e-08 -0.09984573992276227 -2.3588 0.706834674239917 0.7068335568095403 -1.3182313450890715e-08 -0.09984578674796873 -2.3589 0.7068347573649716 0.7068336392502096 -1.1491228644848472e-08 -0.09984583355897247 -2.359 0.7068348404829712 0.7068337216476962 -9.807940445916152e-09 -0.09984588035577784 -2.3590999999999998 0.7068349235938352 0.7068338040020963 -8.132834642717024e-09 -0.0998459271383891 -2.3592000000000004 0.7068350066974782 0.7068338863135101 -6.466295012462486e-09 -0.09984597390681062 -2.3593 0.7068350897938112 0.706833968582042 -4.808703245491597e-09 -0.09984602066104664 -2.3594 0.7068351728827412 0.7068340508077999 -3.1604388489939184e-09 -0.09984606740110147 -2.3595 0.7068352559641708 0.7068341329908969 -1.5218790750184952e-09 -0.09984611412697937 -2.3596 0.7068353390379987 0.7068342151314488 1.0660119228317333e-10 -0.09984616083868464 -2.3597 0.7068354221041198 0.7068342972295767 1.724629491300922e-09 -0.09984620753622162 -2.3598000000000003 0.7068355051624244 0.7068343792854048 3.3318358887840516e-09 -0.09984625421959453 -2.3599 0.7068355882127999 0.7068344612990616 4.927853057903886e-09 -0.09984630088880775 -2.36 0.7068356712551287 0.7068345432706791 6.512316364989945e-09 -0.0998463475438655 -2.3601 0.7068357542892902 0.7068346252003936 8.084863950194587e-09 -0.09984639418477208 -2.3602000000000003 0.7068358373151595 0.7068347070883452 9.645136806422927e-09 -0.09984644081153181 -2.3603 0.706835920332608 0.7068347889346775 1.1192778873875264e-08 -0.09984648742414895 -2.3604000000000003 0.706836003341503 0.7068348707395383 1.2727437105966577e-08 -0.09984653402262778 -2.3605 0.7068360863417085 0.7068349525030787 1.4248761560399503e-08 -0.09984658060697253 -2.3606 0.7068361693330845 0.7068350342254542 1.5756405469420642e-08 -0.09984662717718758 -2.3607000000000005 0.7068362523154874 0.7068351159068232 1.7250025330893537e-08 -0.09984667373327714 -2.3608000000000002 0.7068363352887703 0.7068351975473484 1.8729280975085527e-08 -0.09984672027524555 -2.3609 0.7068364182527818 0.7068352791471955 2.0193835655740733e-08 -0.09984676680309701 -2.361 0.7068365012073674 0.7068353607065341 2.1643356109928014e-08 -0.09984681331683581 -2.3611 0.7068365841523696 0.7068354422255376 2.3077512647379228e-08 -0.0998468598164663 -2.3612 0.7068366670876267 0.7068355237043824 2.4495979212071917e-08 -0.09984690630199262 -2.3613000000000004 0.7068367500129737 0.7068356051432485 2.5898433472434923e-08 -0.09984695277341918 -2.3614 0.7068368329282425 0.7068356865423195 2.72845568846658e-08 -0.09984699923075019 -2.3615 0.7068369158332612 0.7068357679017823 2.8654034768191283e-08 -0.09984704567398989 -2.3615999999999997 0.7068369987278548 0.706835849221827 3.000655636811733e-08 -0.09984709210314262 -2.3617000000000004 0.7068370816118448 0.7068359305026468 3.134181495237365e-08 -0.09984713851821256 -2.3618 0.7068371644850497 0.7068360117444388 3.2659507832530354e-08 -0.09984718491920405 -2.3619 0.7068372473472849 0.7068360929474027 3.3959336486963365e-08 -0.09984723130612133 -2.362 0.7068373301983621 0.7068361741117415 3.524100659381413e-08 -0.09984727767896862 -2.3621 0.7068374130380904 0.7068362552376615 3.650422811078691e-08 -0.09984732403775022 -2.3622 0.7068374958662754 0.7068363363253718 3.774871533065993e-08 -0.09984737038247037 -2.3623000000000003 0.7068375786827203 0.7068364173750846 3.897418696108268e-08 -0.09984741671313332 -2.3624 0.7068376614872249 0.706836498387015 4.018036617314813e-08 -0.09984746302974334 -2.3625 0.7068377442795863 0.7068365793613813 4.1366980675985876e-08 -0.09984750933230473 -2.3626 0.7068378270595985 0.7068366602984043 4.2533762761864935e-08 -0.09984755562082166 -2.3627000000000002 0.7068379098270527 0.7068367411983081 4.36804493911952e-08 -0.0998476018952985 -2.3628 0.7068379925817377 0.7068368220613188 4.4806782220283004e-08 -0.0998476481557394 -2.3629000000000002 0.7068380753234389 0.706836902887666 4.591250770021038e-08 -0.09984769440214863 -2.363 0.7068381580519396 0.7068369836775815 4.6997377087243386e-08 -0.0998477406345305 -2.3630999999999998 0.7068382407670204 0.7068370644312998 4.806114653650717e-08 -0.09984778685288921 -2.3632000000000004 0.7068383234684593 0.706837145149058 4.9103577131476284e-08 -0.09984783305722904 -2.3633 0.7068384061560318 0.7068372258310957 5.012443497071084e-08 -0.09984787924755419 -2.3634 0.7068384888295105 0.7068373064776549 5.112349116265236e-08 -0.09984792542386892 -2.3635 0.7068385714886662 0.70683738708898 5.2100521940115496e-08 -0.09984797158617748 -2.3636 0.7068386541332672 0.7068374676653177 5.3055308672431134e-08 -0.09984801773448404 -2.3637 0.7068387367630793 0.7068375482069171 5.398763792269223e-08 -0.09984806386879293 -2.3638000000000003 0.7068388193778665 0.7068376287140297 5.4897301498060824e-08 -0.09984810998910837 -2.3639 0.7068389019773906 0.7068377091869085 5.578409650701388e-08 -0.09984815609543463 -2.364 0.7068389845614109 0.7068377896258091 5.664782536454749e-08 -0.09984820218777588 -2.3641 0.7068390671296843 0.7068378700309894 5.748829590319915e-08 -0.09984824826613636 -2.3642000000000003 0.7068391496819668 0.7068379504027089 5.8305321340088034e-08 -0.09984829433052039 -2.3643 0.7068392322180115 0.706838030741229 5.909872037059005e-08 -0.09984834038093211 -2.3644000000000003 0.7068393147375702 0.7068381110468132 5.98683171943587e-08 -0.0998483864173758 -2.3645 0.7068393972403927 0.7068381913197266 6.061394155695843e-08 -0.09984843243985567 -2.3646 0.7068394797262267 0.7068382715602365 6.13354287620077e-08 -0.09984847844837597 -2.3647000000000005 0.7068395621948189 0.7068383517686111 6.203261975618046e-08 -0.0998485244429409 -2.3648000000000002 0.7068396446459136 0.7068384319451211 6.270536111185887e-08 -0.09984857042355469 -2.3649 0.7068397270792541 0.706838512090038 6.335350510693061e-08 -0.09984861639022158 -2.365 0.7068398094945818 0.7068385922036355 6.397690972652359e-08 -0.09984866234294579 -2.3651 0.706839891891637 0.7068386722861886 6.457543869943516e-08 -0.09984870828173155 -2.3652 0.7068399742701583 0.7068387523379731 6.514896154150018e-08 -0.09984875420658311 -2.3653000000000004 0.7068400566298829 0.7068388323592668 6.569735356426465e-08 -0.09984880011750459 -2.3654 0.7068401389705473 0.7068389123503485 6.622049591141488e-08 -0.09984884601450028 -2.3655 0.7068402212918862 0.7068389923114982 6.671827559520671e-08 -0.0998488918975744 -2.3655999999999997 0.7068403035936333 0.7068390722429969 6.71905854964655e-08 -0.09984893776673115 -2.3657000000000004 0.7068403858755212 0.7068391521451274 6.763732441662784e-08 -0.09984898362197475 -2.3658 0.706840468137282 0.7068392320181726 6.805839707427208e-08 -0.09984902946330945 -2.3659 0.7068405503786459 0.7068393118624166 6.845371413634338e-08 -0.09984907529073941 -2.366 0.7068406325993432 0.7068393916781444 6.88231922407051e-08 -0.09984912110426887 -2.3661 0.7068407147991023 0.7068394714656421 6.916675399960825e-08 -0.09984916690390198 -2.3662 0.7068407969776521 0.7068395512251966 6.948432803438598e-08 -0.09984921268964306 -2.3663000000000003 0.7068408791347197 0.7068396309570946 6.97758489737188e-08 -0.09984925846149617 -2.3664 0.7068409612700322 0.7068397106616247 7.004125747098189e-08 -0.09984930421946564 -2.3665 0.7068410433833159 0.7068397903390753 7.028050023026589e-08 -0.09984934996355568 -2.3666 0.7068411254742968 0.7068398699897352 7.049352999943803e-08 -0.09984939569377042 -2.3667000000000002 0.7068412075427 0.706839949613894 7.068030557708105e-08 -0.09984944141011406 -2.3668 0.7068412895882508 0.7068400292118413 7.084079184545289e-08 -0.09984948711259084 -2.3669000000000002 0.7068413716106736 0.7068401087838676 7.097495973926171e-08 -0.09984953280120494 -2.367 0.7068414536096939 0.7068401883302632 7.108278628729925e-08 -0.09984957847596061 -2.3670999999999998 0.7068415355850348 0.7068402678513184 7.116425459162412e-08 -0.09984962413686199 -2.3672000000000004 0.7068416175364214 0.706840347347324 7.121935383450073e-08 -0.09984966978391331 -2.3673 0.7068416994635777 0.7068404268185706 7.124807928707289e-08 -0.09984971541711876 -2.3674 0.7068417813662276 0.7068405062653489 7.125043230762906e-08 -0.09984976103648252 -2.3675 0.7068418632440955 0.7068405856879492 7.122642032252047e-08 -0.09984980664200876 -2.3676 0.7068419450969059 0.7068406650866621 7.117605685565132e-08 -0.09984985223370169 -2.3677 0.7068420269243836 0.7068407444617779 7.109936147470242e-08 -0.09984989781156552 -2.3678000000000003 0.7068421087262535 0.7068408238135864 7.099635983970343e-08 -0.09984994337560445 -2.3679 0.7068421905022408 0.7068409031423766 7.086708365966476e-08 -0.09984998892582257 -2.368 0.7068422722520711 0.7068409824484383 7.071157068563871e-08 -0.09985003446222417 -2.3681 0.7068423539754709 0.7068410617320597 7.052986470724998e-08 -0.09985007998481338 -2.3682000000000003 0.7068424356721669 0.7068411409935292 7.032201555096096e-08 -0.09985012549359441 -2.3683 0.7068425173418862 0.7068412202331343 7.008807905231618e-08 -0.09985017098857148 -2.3684000000000003 0.706842598984357 0.7068412994511616 6.98281170507381e-08 -0.0998502164697487 -2.3685 0.7068426805993078 0.7068413786478971 6.954219736003686e-08 -0.09985026193713027 -2.3686 0.7068427621864686 0.7068414578236262 6.923039375800188e-08 -0.0998503073907204 -2.3687000000000005 0.7068428437455693 0.7068415369786332 6.889278597599358e-08 -0.09985035283052321 -2.3688000000000002 0.7068429252763415 0.7068416161132015 6.852945965904467e-08 -0.09985039825654293 -2.3689 0.7068430067785176 0.7068416952276135 6.814050637453384e-08 -0.0998504436687837 -2.369 0.7068430882518308 0.7068417743221507 6.772602355493984e-08 -0.09985048906724966 -2.3691 0.7068431696960159 0.7068418533970935 6.728611450131095e-08 -0.09985053445194508 -2.3692 0.7068432511108083 0.7068419324527208 6.682088834163158e-08 -0.09985057982287406 -2.3693 0.7068433324959449 0.7068420114893106 6.633046001694454e-08 -0.09985062518004081 -2.3694 0.7068434138511641 0.7068420905071393 6.581495021890094e-08 -0.09985067052344948 -2.3695 0.7068434951762055 0.7068421695064822 6.527448542965886e-08 -0.09985071585310425 -2.3695999999999997 0.7068435764708099 0.7068422484876128 6.470919780565687e-08 -0.09985076116900925 -2.3697000000000004 0.7068436577347199 0.7068423274508036 6.411922521404323e-08 -0.09985080647116866 -2.3698 0.7068437389676796 0.706842406396325 6.350471115634804e-08 -0.0998508517595866 -2.3699 0.7068438201694348 0.706842485324446 6.286580476327908e-08 -0.0998508970342673 -2.37 0.7068439013397325 0.7068425642354346 6.220266073227176e-08 -0.09985094229521492 -2.3701 0.7068439824783223 0.7068426431295562 6.151543931014192e-08 -0.09985098754243363 -2.3702 0.7068440635849544 0.7068427220070744 6.080430624971767e-08 -0.09985103277592752 -2.3703000000000003 0.7068441446593821 0.7068428008682515 6.00694327612672e-08 -0.09985107799570081 -2.3704 0.7068442257013594 0.7068428797133475 5.931099548474317e-08 -0.0998511232017576 -2.3705 0.7068443067106434 0.7068429585426206 5.852917642906741e-08 -0.09985116839410213 -2.3706 0.7068443876869922 0.7068430373563267 5.7724162954783664e-08 -0.09985121357273843 -2.3707000000000003 0.7068444686301667 0.7068431161547201 5.6896147694260324e-08 -0.09985125873767074 -2.3708 0.7068445495399298 0.7068431949380527 5.604532854648625e-08 -0.09985130388890318 -2.3709000000000002 0.7068446304160461 0.7068432737065742 5.51719085972735e-08 -0.09985134902643991 -2.371 0.7068447112582832 0.7068433524605322 5.42760960880323e-08 -0.09985139415028509 -2.3710999999999998 0.7068447920664103 0.7068434312001717 5.3358104355055724e-08 -0.09985143926044282 -2.3712000000000004 0.7068448728401994 0.7068435099257355 5.241815179135578e-08 -0.09985148435691732 -2.3713 0.706844953579425 0.706843588637464 5.145646177553975e-08 -0.09985152943971269 -2.3714 0.7068450342838634 0.7068436673355952 5.0473262652728224e-08 -0.09985157450883303 -2.3715 0.7068451149532942 0.7068437460203646 4.9468787628736965e-08 -0.09985161956428257 -2.3716 0.7068451955874988 0.7068438246920051 4.844327477701582e-08 -0.0998516646060654 -2.3717 0.7068452761862619 0.7068439033507468 4.7396966932830575e-08 -0.09985170963418565 -2.3718000000000004 0.7068453567493707 0.7068439819968172 4.633011164989487e-08 -0.09985175464864748 -2.3719 0.7068454372766146 0.7068440606304414 4.524296115353266e-08 -0.09985179964945506 -2.372 0.7068455177677865 0.7068441392518413 4.413577226955456e-08 -0.09985184463661244 -2.3721 0.7068455982226818 0.7068442178612363 4.3008806365277263e-08 -0.09985188961012384 -2.3722000000000003 0.7068456786410984 0.7068442964588426 4.186232929574707e-08 -0.09985193456999333 -2.3723 0.7068457590228376 0.7068443750448741 4.069661133608571e-08 -0.0998519795162251 -2.3724000000000003 0.7068458393677035 0.706844453619541 3.9511927096488875e-08 -0.09985202444882324 -2.3725 0.7068459196755033 0.7068445321830509 3.830855550140955e-08 -0.0998520693677919 -2.3726 0.7068459999460468 0.7068446107356083 3.7086779687209304e-08 -0.09985211427313517 -2.3727000000000005 0.7068460801791476 0.7068446892774148 3.584688695011662e-08 -0.09985215916485723 -2.3728000000000002 0.7068461603746217 0.7068447678086682 3.458916868551154e-08 -0.09985220404296215 -2.3729 0.7068462405322891 0.706844846329564 3.331392029945479e-08 -0.09985224890745412 -2.373 0.7068463206519721 0.7068449248402935 3.202144116358496e-08 -0.0998522937583372 -2.3731 0.7068464007334968 0.7068450033410458 3.071203451970872e-08 -0.0998523385956155 -2.3732 0.7068464807766928 0.7068450818320062 2.938600742428965e-08 -0.09985238341929324 -2.3733 0.7068465607813923 0.7068451603133563 2.8043670677324606e-08 -0.09985242822937446 -2.3734 0.7068466407474319 0.7068452387852749 2.668533874428114e-08 -0.09985247302586331 -2.3735 0.7068467206746507 0.706845317247937 2.531132968497385e-08 -0.09985251780876389 -2.3735999999999997 0.7068468005628916 0.7068453957015141 2.3921965075501817e-08 -0.0998525625780803 -2.3737000000000004 0.7068468804120014 0.7068454741461745 2.2517569940594395e-08 -0.09985260733381672 -2.3738 0.7068469602218297 0.7068455525820829 2.1098472667742396e-08 -0.09985265207597721 -2.3739 0.7068470399922298 0.7068456310094002 1.9665004940411235e-08 -0.09985269680456582 -2.374 0.7068471197230592 0.7068457094282841 1.821750164696795e-08 -0.0998527415195868 -2.3741 0.7068471994141783 0.7068457878388881 1.675630081736379e-08 -0.09985278622104414 -2.3742 0.7068472790654518 0.7068458662413625 1.528174353639805e-08 -0.09985283090894198 -2.3743000000000003 0.7068473586767478 0.7068459446358538 1.3794173865655512e-08 -0.09985287558328451 -2.3744 0.7068474382479378 0.7068460230225047 1.2293938763709156e-08 -0.09985292024407573 -2.3745 0.706847517778898 0.706846101401454 1.078138800632289e-08 -0.09985296489131984 -2.3746 0.7068475972695072 0.706846179772837 9.256874098848011e-09 -0.09985300952502085 -2.3747000000000003 0.7068476767196488 0.7068462581367849 7.720752207701631e-09 -0.0998530541451829 -2.3748 0.7068477561292099 0.7068463364934253 6.1733800554159e-09 -0.09985309875181012 -2.3749000000000002 0.7068478354980814 0.7068464148428817 4.615117861657414e-09 -0.09985314334490658 -2.375 0.7068479148261579 0.7068464931852736 3.0463282443479733e-09 -0.09985318792447632 -2.3750999999999998 0.7068479941133383 0.7068465715207173 1.4673761363978577e-09 -0.09985323249052352 -2.3752000000000004 0.7068480733595253 0.7068466498493242 -1.2137128801992247e-10 -0.09985327704305225 -2.3753 0.7068481525646255 0.7068467281712024 -1.7195447132162256e-09 -0.09985332158206661 -2.3754 0.7068482317285496 0.7068468064864557 -3.326772761783059e-09 -0.09985336610757072 -2.3755 0.706848310851212 0.7068468847951839 -4.942682081329752e-09 -0.0998534106195686 -2.3756 0.7068483899325315 0.706846963097483 -6.566897428617047e-09 -0.0998534551180644 -2.3757 0.706848468972431 0.7068470413934445 -8.199041754558545e-09 -0.09985349960306221 -2.3758000000000004 0.7068485479708372 0.7068471196831562 -9.838736300497863e-09 -0.09985354407456609 -2.3759 0.7068486269276808 0.7068471979667017 -1.1485600679740637e-08 -0.09985358853258014 -2.376 0.7068487058428967 0.7068472762441604 -1.3139252970362225e-08 -0.0998536329771084 -2.3761 0.7068487847164244 0.7068473545156078 -1.4799309792402904e-08 -0.09985367740815504 -2.3762000000000003 0.7068488635482069 0.706847432781115 -1.646538641802281e-08 -0.09985372182572408 -2.3763 0.7068489423381912 0.7068475110407494 -1.8137096834385663e-08 -0.09985376622981962 -2.3764000000000003 0.7068490210863294 0.7068475892945736 -1.9814053855114755e-08 -0.09985381062044574 -2.3765 0.706849099792577 0.7068476675426466 -2.1495869195753414e-08 -0.09985385499760657 -2.3766 0.706849178456894 0.7068477457850227 -2.318215357264425e-08 -0.09985389936130612 -2.3767000000000005 0.7068492570792442 0.7068478240217525 -2.487251678576219e-08 -0.09985394371154849 -2.3768000000000002 0.706849335659596 0.7068479022528821 -2.6566567816726366e-08 -0.09985398804833778 -2.3769 0.7068494141979219 0.7068479804784533 -2.8263914911199478e-08 -0.09985403237167803 -2.377 0.7068494926941986 0.706848058698504 -2.996416567451442e-08 -0.09985407668157331 -2.3771 0.7068495711484069 0.7068481369130676 -3.166692716231358e-08 -0.09985412097802772 -2.3772 0.706849649560532 0.7068482151221734 -3.337180596836922e-08 -0.0998541652610453 -2.3773 0.7068497279305633 0.7068482933258466 -3.507840831695752e-08 -0.09985420953063019 -2.3774 0.7068498062584944 0.7068483715241081 -3.6786340155557824e-08 -0.09985425378678639 -2.3775 0.7068498845443227 0.706848449716974 -3.8495207243215146e-08 -0.09985429802951795 -2.3775999999999997 0.7068499627880509 0.7068485279044571 -4.020461524264314e-08 -0.09985434225882897 -2.3777000000000004 0.706850040989685 0.7068486060865654 -4.191416981080918e-08 -0.09985438647472356 -2.3778 0.7068501191492353 0.7068486842633026 -4.36234766902242e-08 -0.09985443067720572 -2.3779 0.7068501972667167 0.7068487624346685 -4.5332141800286715e-08 -0.09985447486627948 -2.378 0.7068502753421482 0.7068488406006588 -4.7039771326892136e-08 -0.09985451904194902 -2.3781 0.706850353375553 0.7068489187612641 -4.874597181437311e-08 -0.0998545632042183 -2.3782 0.7068504313669587 0.7068489969164717 -5.045035025429568e-08 -0.09985460735309146 -2.3783000000000003 0.7068505093163964 0.7068490750662643 -5.215251417745384e-08 -0.09985465148857242 -2.3784 0.7068505872239024 0.7068491532106205 -5.38520717459183e-08 -0.09985469561066539 -2.3785 0.7068506650895167 0.7068492313495146 -5.554863183928477e-08 -0.09985473971937438 -2.3786 0.7068507429132832 0.7068493094829165 -5.724180414650587e-08 -0.09985478381470338 -2.3787000000000003 0.7068508206952505 0.7068493876107924 -5.893119925793992e-08 -0.0998548278966565 -2.3788 0.7068508984354713 0.7068494657331041 -6.061642874970186e-08 -0.09985487196523779 -2.3789000000000002 0.7068509761340022 0.7068495438498092 -6.229710527820564e-08 -0.09985491602045132 -2.379 0.706851053790904 0.7068496219608611 -6.397284266516576e-08 -0.0998549600623011 -2.3790999999999998 0.7068511314062416 0.7068497000662093 -6.564325598888698e-08 -0.09985500409079116 -2.3792000000000004 0.7068512089800842 0.7068497781657987 -6.730796167121744e-08 -0.09985504810592559 -2.3793 0.7068512865125051 0.7068498562595711 -6.89665775677542e-08 -0.09985509210770846 -2.3794 0.7068513640035814 0.7068499343474629 -7.061872305197739e-08 -0.09985513609614376 -2.3795 0.7068514414533944 0.7068500124294073 -7.226401910588945e-08 -0.09985518007123553 -2.3796 0.7068515188620299 0.706850090505333 -7.39020884037156e-08 -0.09985522403298784 -2.3797 0.7068515962295768 0.7068501685751649 -7.553255540124204e-08 -0.09985526798140466 -2.3798000000000004 0.7068516735561289 0.7068502466388243 -7.715504642298587e-08 -0.09985531191649016 -2.3799 0.7068517508417835 0.7068503246962278 -7.87691897402576e-08 -0.09985535583824828 -2.38 0.706851828086642 0.7068504027472882 -8.03746156670046e-08 -0.09985539974668312 -2.3801 0.7068519052908097 0.7068504807919144 -8.197095663613901e-08 -0.0998554436417986 -2.3802000000000003 0.706851982454396 0.7068505588300117 -8.35578472897433e-08 -0.09985548752359892 -2.3803 0.7068520595775135 0.7068506368614811 -8.513492455886756e-08 -0.09985553139208793 -2.3804000000000003 0.7068521366602798 0.70685071488622 -8.670182773985735e-08 -0.09985557524726979 -2.3805 0.7068522137028155 0.7068507929041219 -8.8258198595835e-08 -0.09985561908914857 -2.3806 0.7068522907052455 0.706850870915076 -8.980368141914968e-08 -0.09985566291772817 -2.3807000000000005 0.7068523676676979 0.7068509489189685 -9.13379231241851e-08 -0.0998557067330127 -2.3808000000000002 0.706852444590305 0.7068510269156814 -9.286057331935049e-08 -0.09985575053500619 -2.3809 0.7068525214732029 0.706851104905093 -9.437128440075576e-08 -0.09985579432371261 -2.381 0.7068525983165312 0.7068511828870777 -9.586971161292673e-08 -0.09985583809913605 -2.3811 0.7068526751204329 0.7068512608615066 -9.735551313901081e-08 -0.09985588186128046 -2.3812 0.7068527518850554 0.7068513388282472 -9.882835018664576e-08 -0.09985592561014991 -2.3813 0.7068528286105487 0.7068514167871631 -1.0028788704260355e-07 -0.09985596934574845 -2.3814 0.7068529052970671 0.7068514947381144 -1.0173379117253689e-07 -0.09985601306808001 -2.3815 0.7068529819447682 0.7068515726809577 -1.0316573327909251e-07 -0.09985605677714868 -2.3815999999999997 0.7068530585538133 0.7068516506155461 -1.0458338738604522e-07 -0.09985610047295847 -2.3817000000000004 0.7068531351243665 0.7068517285417295 -1.0598643091289106e-07 -0.09985614415551339 -2.3818 0.7068532116565962 0.706851806459354 -1.0737454474076674e-07 -0.09985618782481742 -2.3819 0.7068532881506735 0.7068518843682623 -1.0874741329658377e-07 -0.09985623148087462 -2.382 0.7068533646067734 0.7068519622682943 -1.1010472461374377e-07 -0.09985627512368901 -2.3821 0.7068534410250735 0.7068520401592856 -1.1144617040846627e-07 -0.09985631875326456 -2.3822 0.7068535174057553 0.7068521180410696 -1.1277144615004508e-07 -0.0998563623696053 -2.3823000000000003 0.7068535937490033 0.7068521959134759 -1.1408025112763509e-07 -0.09985640597271518 -2.3824 0.706853670055005 0.706852273776331 -1.1537228851443704e-07 -0.09985644956259833 -2.3825 0.7068537463239513 0.7068523516294583 -1.1664726544229065e-07 -0.09985649313925861 -2.3826 0.7068538225560361 0.7068524294726782 -1.1790489307973717e-07 -0.09985653670270023 -2.3827000000000003 0.7068538987514565 0.7068525073058078 -1.1914488666150969e-07 -0.09985658025292701 -2.3828 0.7068539749104124 0.7068525851286611 -1.2036696558914706e-07 -0.09985662378994298 -2.3829000000000002 0.7068540510331065 0.7068526629410499 -1.2157085347783148e-07 -0.09985666731375223 -2.383 0.7068541271197449 0.706852740742782 -1.227562782118996e-07 -0.09985671082435871 -2.3830999999999998 0.7068542031705359 0.7068528185336633 -1.2392297202984404e-07 -0.09985675432176641 -2.3832000000000004 0.7068542791856913 0.7068528963134961 -1.250706715624772e-07 -0.0998567978059793 -2.3833 0.7068543551654252 0.7068529740820806 -1.2619911789885085e-07 -0.0998568412770014 -2.3834 0.7068544311099548 0.7068530518392135 -1.2730805665044087e-07 -0.09985688473483674 -2.3835 0.7068545070194996 0.7068531295846898 -1.283972379945153e-07 -0.09985692817948927 -2.3836 0.7068545828942818 0.706853207318301 -1.294664167556664e-07 -0.09985697161096298 -2.3837 0.7068546587345264 0.7068532850398366 -1.305153524370356e-07 -0.09985701502926189 -2.3838000000000004 0.7068547345404612 0.7068533627490834 -1.3154380927582476e-07 -0.09985705843439006 -2.3839 0.7068548103123156 0.7068534404458251 -1.3255155631615445e-07 -0.09985710182635138 -2.384 0.7068548860503217 0.7068535181298441 -1.3353836744028902e-07 -0.09985714520514982 -2.3841 0.7068549617547146 0.7068535958009198 -1.3450402142588247e-07 -0.09985718857078946 -2.3842000000000003 0.706855037425731 0.7068536734588291 -1.3544830198934654e-07 -0.09985723192327421 -2.3843 0.7068551130636103 0.706853751103347 -1.363709978587091e-07 -0.0998572752626081 -2.3844000000000003 0.7068551886685936 0.7068538287342465 -1.3727190279269608e-07 -0.0998573185887951 -2.3845 0.7068552642409247 0.7068539063512974 -1.3815081562930376e-07 -0.09985736190183914 -2.3846 0.7068553397808492 0.7068539839542689 -1.3900754036386131e-07 -0.09985740520174427 -2.3847000000000005 0.7068554152886151 0.7068540615429271 -1.398418861403572e-07 -0.0998574484885145 -2.3848000000000003 0.7068554907644717 0.7068541391170362 -1.4065366733991003e-07 -0.09985749176215372 -2.3849 0.7068555662086706 0.706854216676359 -1.4144270358597277e-07 -0.09985753502266595 -2.385 0.7068556416214654 0.7068542942206559 -1.422088198154564e-07 -0.09985757827005515 -2.3851 0.7068557170031116 0.7068543717496857 -1.4295184630128133e-07 -0.09985762150432531 -2.3852 0.7068557923538659 0.7068544492632054 -1.436716186888065e-07 -0.09985766472548041 -2.3853 0.7068558676739869 0.7068545267609705 -1.4436797803225876e-07 -0.09985770793352439 -2.3854 0.7068559429637353 0.7068546042427345 -1.4504077084677436e-07 -0.09985775112846122 -2.3855 0.7068560182233732 0.7068546817082496 -1.456898491083991e-07 -0.09985779431029496 -2.3855999999999997 0.7068560934531638 0.7068547591572664 -1.4631507032347724e-07 -0.09985783747902945 -2.3857000000000004 0.7068561686533721 0.706854836589534 -1.4691629753212088e-07 -0.09985788063466876 -2.3858 0.7068562438242643 0.7068549140047999 -1.4749339936198647e-07 -0.09985792377721679 -2.3859 0.7068563189661085 0.706854991402811 -1.480462500230706e-07 -0.09985796690667759 -2.386 0.7068563940791732 0.7068550687833117 -1.4857472937189475e-07 -0.09985801002305501 -2.3861 0.7068564691637289 0.7068551461460464 -1.4907872291844426e-07 -0.09985805312635314 -2.3862 0.7068565442200467 0.7068552234907574 -1.4955812184178074e-07 -0.09985809621657583 -2.3863000000000003 0.7068566192483992 0.7068553008171865 -1.5001282304728802e-07 -0.0998581392937271 -2.3864 0.7068566942490596 0.7068553781250744 -1.5044272915279433e-07 -0.09985818235781088 -2.3865 0.7068567692223026 0.7068554554141603 -1.5084774852153204e-07 -0.09985822540883114 -2.3866 0.7068568441684033 0.7068555326841832 -1.5122779529336272e-07 -0.09985826844679187 -2.3867000000000003 0.7068569190876381 0.7068556099348811 -1.5158278938130765e-07 -0.099858311471697 -2.3868 0.7068569939802841 0.7068556871659903 -1.519126565131812e-07 -0.09985835448355049 -2.3869000000000002 0.7068570688466187 0.7068557643772477 -1.5221732821944778e-07 -0.09985839748235624 -2.387 0.7068571436869202 0.7068558415683889 -1.5249674186271212e-07 -0.09985844046811829 -2.3870999999999998 0.7068572185014677 0.7068559187391488 -1.5275084066720956e-07 -0.09985848344084051 -2.3872000000000004 0.7068572932905406 0.7068559958892617 -1.529795736823769e-07 -0.0998585264005269 -2.3873 0.7068573680544192 0.7068560730184621 -1.5318289584703715e-07 -0.0998585693471814 -2.3874 0.7068574427933834 0.7068561501264832 -1.5336076797552167e-07 -0.09985861228080795 -2.3875 0.7068575175077141 0.7068562272130583 -1.535131567351189e-07 -0.09985865520141052 -2.3876 0.7068575921976924 0.7068563042779206 -1.5364003470158538e-07 -0.099858698108993 -2.3877 0.7068576668635994 0.7068563813208026 -1.5374138033485973e-07 -0.09985874100355939 -2.3878000000000004 0.7068577415057167 0.706856458341437 -1.5381717800161399e-07 -0.0998587838851136 -2.3879 0.7068578161243255 0.7068565353395562 -1.538674179457633e-07 -0.09985882675365959 -2.388 0.7068578907197075 0.7068566123148927 -1.5389209631448686e-07 -0.09985886960920132 -2.3881 0.7068579652921441 0.706856689267179 -1.5389121515302362e-07 -0.09985891245174268 -2.3882000000000003 0.7068580398419164 0.7068567661961479 -1.5386478239946821e-07 -0.09985895528128765 -2.3883 0.7068581143693061 0.7068568431015316 -1.538128118830362e-07 -0.09985899809784012 -2.3884000000000003 0.706858188874594 0.7068569199830639 -1.5373532331885986e-07 -0.09985904090140413 -2.3885 0.7068582633580605 0.706856996840477 -1.5363234228890632e-07 -0.09985908369198347 -2.3886 0.7068583378199864 0.7068570736735049 -1.535039002662636e-07 -0.09985912646958219 -2.3887000000000005 0.7068584122606515 0.7068571504818818 -1.5335003457177254e-07 -0.09985916923420417 -2.3888000000000003 0.7068584866803351 0.706857227265342 -1.531707883757616e-07 -0.09985921198585332 -2.3889 0.7068585610793161 0.7068573040236203 -1.5296621069457728e-07 -0.09985925472453361 -2.389 0.7068586354578729 0.7068573807564527 -1.5273635636803284e-07 -0.09985929745024892 -2.3891 0.7068587098162832 0.7068574574635751 -1.5248128605246936e-07 -0.09985934016300325 -2.3892 0.706858784154824 0.7068575341447246 -1.5220106620514318e-07 -0.0998593828628005 -2.3893 0.7068588584737712 0.7068576107996392 -1.518957690425926e-07 -0.09985942554964458 -2.3894 0.7068589327734003 0.706857687428057 -1.5156547256492403e-07 -0.09985946822353939 -2.3895 0.7068590070539857 0.7068577640297176 -1.5121026050030073e-07 -0.09985951088448887 -2.3895999999999997 0.7068590813158007 0.706857840604362 -1.5083022229800402e-07 -0.099859553532497 -2.3897000000000004 0.7068591555591175 0.7068579171517312 -1.5042545311629019e-07 -0.09985959616756762 -2.3898 0.7068592297842077 0.706857993671568 -1.499960537668793e-07 -0.09985963878970469 -2.3899 0.7068593039913413 0.706858070163616 -1.4954213073403722e-07 -0.09985968139891212 -2.39 0.7068593781807873 0.7068581466276203 -1.4906379611386023e-07 -0.09985972399519383 -2.3901 0.7068594523528133 0.7068582230633269 -1.485611675951931e-07 -0.09985976657855371 -2.3902 0.7068595265076857 0.7068582994704835 -1.4803436843881246e-07 -0.09985980914899573 -2.3903000000000003 0.7068596006456691 0.7068583758488391 -1.474835274357933e-07 -0.09985985170652373 -2.3904 0.706859674767027 0.706858452198144 -1.4690877888148823e-07 -0.09985989425114168 -2.3905 0.7068597488720219 0.7068585285181502 -1.4631026255991497e-07 -0.09985993678285349 -2.3906 0.7068598229609134 0.706858604808611 -1.4568812367263262e-07 -0.099859979301663 -2.3907000000000003 0.7068598970339608 0.7068586810692816 -1.4504251283527225e-07 -0.09986002180757421 -2.3908 0.7068599710914207 0.706858757299919 -1.4437358603763828e-07 -0.09986006430059097 -2.3909000000000002 0.7068600451335488 0.7068588335002812 -1.4368150458819728e-07 -0.09986010678071716 -2.391 0.7068601191605985 0.7068589096701291 -1.4296643508632245e-07 -0.09986014924795682 -2.3911 0.7068601931728216 0.7068589858092247 -1.422285493875991e-07 -0.09986019170231375 -2.3912000000000004 0.7068602671704675 0.7068590619173316 -1.4146802455178298e-07 -0.09986023414379183 -2.3913 0.7068603411537844 0.7068591379942166 -1.406850428098405e-07 -0.09986027657239507 -2.3914 0.7068604151230176 0.706859214039647 -1.3987979151364183e-07 -0.09986031898812721 -2.3915 0.7068604890784109 0.7068592900533934 -1.390524630943274e-07 -0.09986036139099229 -2.3916 0.7068605630202061 0.706859366035228 -1.3820325501547048e-07 -0.09986040378099413 -2.3917 0.7068606369486422 0.706859441984925 -1.373323697314438e-07 -0.09986044615813663 -2.3918000000000004 0.7068607108639567 0.7068595179022613 -1.364400146284389e-07 -0.09986048852242374 -2.3919 0.7068607847663841 0.7068595937870158 -1.3552640197589394e-07 -0.0998605308738593 -2.392 0.7068608586561573 0.7068596696389697 -1.3459174889873804e-07 -0.09986057321244722 -2.3921 0.706860932533506 0.7068597454579069 -1.3363627729412464e-07 -0.09986061553819144 -2.3922000000000003 0.706861006398658 0.7068598212436135 -1.326602137915328e-07 -0.0998606578510958 -2.3923 0.7068610802518385 0.7068598969958775 -1.3166378970939918e-07 -0.09986070015116413 -2.3924000000000003 0.7068611540932699 0.7068599727144907 -1.3064724098225955e-07 -0.0998607424384004 -2.3925 0.7068612279231725 0.7068600483992469 -1.296108081243197e-07 -0.09986078471280851 -2.3926 0.7068613017417638 0.7068601240499424 -1.2855473615833168e-07 -0.09986082697439236 -2.3927000000000005 0.7068613755492581 0.7068601996663759 -1.2747927454967445e-07 -0.09986086922315579 -2.3928000000000003 0.7068614493458676 0.7068602752483493 -1.2638467717686341e-07 -0.09986091145910263 -2.3929 0.7068615231318014 0.7068603507956672 -1.2527120225348798e-07 -0.09986095368223684 -2.393 0.7068615969072656 0.7068604263081372 -1.241391122536184e-07 -0.09986099589256225 -2.3931 0.706861670672464 0.7068605017855694 -1.229886738753766e-07 -0.09986103809008277 -2.3932 0.7068617444275971 0.706860577227777 -1.2182015797154722e-07 -0.09986108027480227 -2.3933 0.7068618181728623 0.706860652634576 -1.2063383946978035e-07 -0.09986112244672465 -2.3934 0.7068618919084548 0.7068607280057858 -1.194299973274887e-07 -0.0998611646058538 -2.3935 0.7068619656345656 0.7068608033412285 -1.1820891445898929e-07 -0.09986120675219357 -2.3935999999999997 0.7068620393513831 0.7068608786407291 -1.1697087766437964e-07 -0.09986124888574782 -2.3937000000000004 0.7068621130590931 0.7068609539041165 -1.157161775705573e-07 -0.09986129100652047 -2.3938 0.7068621867578773 0.7068610291312218 -1.1444510855489198e-07 -0.09986133311451534 -2.3939 0.7068622604479146 0.70686110432188 -1.1315796868797967e-07 -0.09986137520973629 -2.394 0.7068623341293809 0.706861179475929 -1.1185505965211062e-07 -0.09986141729218723 -2.3941 0.7068624078024488 0.7068612545932101 -1.1053668667014571e-07 -0.09986145936187205 -2.3942 0.706862481467287 0.7068613296735679 -1.0920315844480111e-07 -0.09986150141879453 -2.3943000000000003 0.7068625551240615 0.7068614047168502 -1.0785478707538154e-07 -0.09986154346295861 -2.3944 0.7068626287729347 0.7068614797229085 -1.0649188799879972e-07 -0.09986158549436813 -2.3945 0.7068627024140652 0.7068615546915975 -1.0511477989850332e-07 -0.09986162751302698 -2.3946 0.7068627760476087 0.7068616296227759 -1.0372378464115761e-07 -0.09986166951893903 -2.3947000000000003 0.706862849673717 0.7068617045163048 -1.023192271959808e-07 -0.0998617115121081 -2.3948 0.7068629232925387 0.70686177937205 -1.00901435562753e-07 -0.09986175349253808 -2.3949000000000003 0.7068629969042184 0.7068618541898797 -9.947074069462103e-08 -0.09986179546023277 -2.395 0.7068630705088974 0.7068619289696665 -9.80274764200359e-08 -0.09986183741519608 -2.3951 0.7068631441067137 0.7068620037112868 -9.657197936642492e-08 -0.09986187935743192 -2.3952000000000004 0.7068632176978008 0.7068620784146198 -9.510458887605766e-08 -0.09986192128694403 -2.3953 0.7068632912822892 0.706862153079549 -9.362564693578962e-08 -0.09986196320373632 -2.3954 0.7068633648603055 0.7068622277059617 -9.213549809292815e-08 -0.09986200510781268 -2.3955 0.7068634384319727 0.7068623022937481 -9.063448937370044e-08 -0.09986204699917689 -2.3956 0.7068635119974098 0.7068623768428033 -8.912297019651738e-08 -0.09986208887783284 -2.3957 0.706863585556732 0.7068624513530253 -8.760129231212554e-08 -0.0998621307437844 -2.3958000000000004 0.7068636591100511 0.7068625258243162 -8.606980969518702e-08 -0.09986217259703538 -2.3959 0.7068637326574745 0.7068626002565823 -8.452887848182933e-08 -0.09986221443758966 -2.396 0.7068638061991062 0.7068626746497328 -8.297885687423567e-08 -0.09986225626545106 -2.3961 0.7068638797350459 0.7068627490036818 -8.14201050703886e-08 -0.09986229808062343 -2.3962000000000003 0.70686395326539 0.7068628233183467 -7.985298516172135e-08 -0.0998623398831106 -2.3963 0.7068640267902304 0.7068628975936488 -7.827786106372886e-08 -0.09986238167291644 -2.3964000000000003 0.7068641003096556 0.7068629718295136 -7.669509843443584e-08 -0.09986242345004478 -2.3965 0.70686417382375 0.7068630460258706 -7.510506457378274e-08 -0.0998624652144995 -2.3966 0.7068642473325935 0.7068631201826527 -7.350812835250214e-08 -0.09986250696628436 -2.3967 0.7068643208362624 0.7068631942997975 -7.19046601219131e-08 -0.09986254870540325 -2.3968000000000003 0.7068643943348292 0.7068632683772462 -7.029503162545025e-08 -0.09986259043186002 -2.3969 0.7068644678283622 0.7068633424149441 -6.867961591279503e-08 -0.09986263214565849 -2.397 0.7068645413169257 0.7068634164128401 -6.705878726007836e-08 -0.09986267384680242 -2.3971 0.70686461480058 0.7068634903708879 -6.54329210757719e-08 -0.09986271553529576 -2.3972 0.7068646882793814 0.7068635642890448 -6.380239381568661e-08 -0.09986275721114232 -2.3973 0.7068647617533819 0.7068636381672722 -6.216758289970606e-08 -0.09986279887434588 -2.3974 0.7068648352226296 0.7068637120055354 -6.052886661637655e-08 -0.0998628405249103 -2.3975 0.7068649086871687 0.7068637858038043 -5.888662404701303e-08 -0.09986288216283945 -2.3975999999999997 0.7068649821470387 0.7068638595620522 -5.724123496790405e-08 -0.09986292378813706 -2.3977000000000004 0.7068650556022759 0.706863933280257 -5.559307976552713e-08 -0.09986296540080704 -2.3978 0.706865129052912 0.7068640069584003 -5.394253934981261e-08 -0.09986300700085321 -2.3979 0.7068652024989741 0.7068640805964681 -5.2289995066756925e-08 -0.09986304858827932 -2.398 0.7068652759404862 0.7068641541944505 -5.063582860669914e-08 -0.09986309016308924 -2.3981 0.7068653493774679 0.7068642277523414 -4.898042192116262e-08 -0.09986313172528684 -2.3982 0.7068654228099343 0.7068643012701391 -4.732415713221572e-08 -0.09986317327487587 -2.3983000000000003 0.7068654962378964 0.7068643747478458 -4.566741644096515e-08 -0.09986321481186015 -2.3984 0.7068655696613622 0.7068644481854679 -4.40105820453192e-08 -0.09986325633624359 -2.3985 0.7068656430803337 0.7068645215830158 -4.235403604916553e-08 -0.09986329784802989 -2.3986 0.7068657164948101 0.7068645949405044 -4.069816037478792e-08 -0.0998633393472229 -2.3987000000000003 0.7068657899047867 0.706864668257952 -3.9043336671617124e-08 -0.09986338083382651 -2.3988 0.7068658633102536 0.7068647415353817 -3.738994623441426e-08 -0.09986342230784441 -2.3989000000000003 0.7068659367111979 0.70686481477282 -3.57383699100362e-08 -0.0998634637692805 -2.399 0.7068660101076019 0.7068648879702986 -3.408898801302365e-08 -0.09986350521813858 -2.3991 0.7068660834994442 0.7068649611278517 -3.2442180235422655e-08 -0.09986354665442247 -2.3992000000000004 0.7068661568866992 0.7068650342455189 -3.079832556259626e-08 -0.09986358807813599 -2.3993 0.7068662302693371 0.7068651073233432 -2.915780218399472e-08 -0.0998636294892829 -2.3994 0.7068663036473242 0.7068651803613715 -2.7520987404359293e-08 -0.09986367088786699 -2.3995 0.7068663770206227 0.7068652533596554 -2.5888257561973438e-08 -0.09986371227389212 -2.3996 0.7068664503891908 0.70686532631825 -2.4259987936939287e-08 -0.09986375364736205 -2.3997 0.706866523752983 0.7068653992372149 -2.2636552668778287e-08 -0.09986379500828066 -2.3998000000000004 0.706866597111949 0.706865472116613 -2.1018324670128707e-08 -0.09986383635665169 -2.3999 0.7068666704660354 0.7068655449565119 -1.940567553784106e-08 -0.09986387769247895 -2.4 0.706866743815184 0.7068656177569823 -1.7798975467976652e-08 -0.09986391901576622 -2.4001 0.7068668171593334 0.7068656905180999 -1.6198593178178705e-08 -0.09986396032651734 -2.4002000000000003 0.7068668904984179 0.7068657632399438 -1.4604895814430974e-08 -0.09986400162473612 -2.4003 0.7068669638323678 0.7068658359225969 -1.301824886952574e-08 -0.09986404291042632 -2.4004000000000003 0.7068670371611095 0.7068659085661462 -1.143901610283285e-08 -0.09986408418359174 -2.4005 0.7068671104845661 0.7068659811706823 -9.867559448793056e-09 -0.09986412544423623 -2.4006 0.7068671838026557 0.7068660537363003 -8.304238945794351e-09 -0.09986416669236349 -2.4007 0.7068672571152934 0.7068661262630984 -6.749412640762176e-09 -0.09986420792797736 -2.4008000000000003 0.7068673304223902 0.7068661987511793 -5.203436517602078e-09 -0.09986424915108165 -2.4009 0.7068674037238536 0.7068662712006488 -3.666664414800347e-09 -0.09986429036168008 -2.401 0.7068674770195867 0.7068663436116172 -2.139447933049987e-09 -0.0998643315597765 -2.4011 0.7068675503094898 0.7068664159841977 -6.221363641270572e-10 -0.09986437274537473 -2.4012000000000002 0.7068676235934586 0.7068664883185081 8.849233837024406e-10 -0.09986441391847849 -2.4013 0.7068676968713852 0.7068665606146691 2.381386874153457e-09 -0.09986445507909157 -2.4014 0.7068677701431586 0.7068666328728057 3.8669122227191766e-09 -0.09986449622721776 -2.4015 0.7068678434086637 0.7068667050930459 5.341160162590508e-09 -0.09986453736286081 -2.4015999999999997 0.7068679166677818 0.7068667772755224 6.8037941365964305e-09 -0.09986457848602458 -2.4017000000000004 0.7068679899203909 0.7068668494203703 8.254480363123484e-09 -0.09986461959671283 -2.4018 0.7068680631663653 0.7068669215277286 9.692887921984583e-09 -0.09986466069492929 -2.4019 0.7068681364055753 0.7068669935977401 1.111868882207323e-08 -0.09986470178067777 -2.402 0.7068682096378889 0.7068670656305511 1.2531558075956628e-08 -0.0998647428539621 -2.4021 0.7068682828631694 0.7068671376263109 1.3931173778805594e-08 -0.09986478391478598 -2.4022 0.7068683560812772 0.7068672095851727 1.5317217182120313e-08 -0.09986482496315319 -2.4023000000000003 0.7068684292920695 0.7068672815072927 1.6689372761384547e-08 -0.09986486599906758 -2.4024 0.7068685024953998 0.7068673533928304 1.8047328285454578e-08 -0.0998649070225328 -2.4025 0.7068685756911186 0.706867425241949 1.939077490156066e-08 -0.0998649480335527 -2.4026 0.7068686488790727 0.706867497054815 2.0719407192552886e-08 -0.09986498903213105 -2.4027000000000003 0.7068687220591061 0.7068675688315976 2.20329232471575e-08 -0.0998650300182716 -2.4028 0.7068687952310595 0.7068676405724696 2.333102473196791e-08 -0.09986507099197811 -2.4029000000000003 0.7068688683947704 0.7068677122776073 2.4613416962568357e-08 -0.09986511195325441 -2.403 0.7068689415500728 0.7068677839471889 2.5879808955575623e-08 -0.09986515290210418 -2.4031 0.7068690146967982 0.706867855581397 2.712991352404881e-08 -0.09986519383853126 -2.4032000000000004 0.7068690878347748 0.7068679271804166 2.836344730264284e-08 -0.09986523476253932 -2.4033 0.7068691609638278 0.7068679987444357 2.958013085342659e-08 -0.09986527567413223 -2.4034 0.7068692340837797 0.7068680702736456 3.077968868669956e-08 -0.09986531657331367 -2.4035 0.7068693071944494 0.70686814176824 3.1961849366810013e-08 -0.09986535746008744 -2.4036 0.7068693802956536 0.7068682132284158 3.312634553991056e-08 -0.09986539833445729 -2.4037 0.7068694533872062 0.7068682846543723 3.4272914012020705e-08 -0.09986543919642694 -2.4038000000000004 0.7068695264689179 0.7068683560463125 3.540129579933382e-08 -0.09986548004600024 -2.4039 0.7068695995405969 0.7068684274044412 3.651123619240193e-08 -0.09986552088318086 -2.404 0.7068696726020489 0.7068684987289662 3.760248480470796e-08 -0.0998655617079726 -2.4041 0.7068697456530764 0.7068685700200981 3.867479564725884e-08 -0.09986560252037922 -2.4042000000000003 0.7068698186934799 0.7068686412780496 3.972792716328e-08 -0.09986564332040443 -2.4043 0.7068698917230567 0.7068687125030366 4.076164229586954e-08 -0.09986568410805198 -2.4044 0.7068699647416026 0.7068687836952772 4.177570854524415e-08 -0.0998657248833257 -2.4045 0.7068700377489099 0.7068688548549915 4.2769897996494666e-08 -0.09986576564622922 -2.4046 0.7068701107447696 0.7068689259824027 4.374398739764862e-08 -0.0998658063967664 -2.4047 0.7068701837289693 0.706868997077736 4.469775819956889e-08 -0.09986584713494094 -2.4048000000000003 0.7068702567012946 0.7068690681412185 4.563099660799541e-08 -0.09986588786075654 -2.4049 0.7068703296615293 0.7068691391730806 4.654349361303545e-08 -0.099865928574217 -2.405 0.706870402609455 0.7068692101735536 4.743504507416507e-08 -0.0998659692753261 -2.4051 0.7068704755448504 0.7068692811428718 4.8305451720229153e-08 -0.09986600996408747 -2.4052000000000002 0.7068705484674926 0.7068693520812713 4.9154519229238636e-08 -0.09986605064050491 -2.4053 0.7068706213771573 0.7068694229889905 4.9982058256126116e-08 -0.0998660913045822 -2.4054 0.706870694273617 0.706869493866269 5.0787884483052825e-08 -0.09986613195632302 -2.4055 0.7068707671566432 0.7068695647133493 5.157181864022531e-08 -0.09986617259573115 -2.4055999999999997 0.7068708400260053 0.7068696355304749 5.233368657701909e-08 -0.09986621322281025 -2.4057000000000004 0.7068709128814703 0.7068697063178917 5.307331927759118e-08 -0.0998662538375641 -2.4058 0.7068709857228048 0.7068697770758472 5.3790552899044e-08 -0.0998662944399965 -2.4059 0.7068710585497723 0.7068698478045905 5.4485228826936516e-08 -0.09986633503011111 -2.406 0.7068711313621354 0.7068699185043723 5.5157193689162054e-08 -0.09986637560791167 -2.4061 0.706871204159655 0.706869989175445 5.580629938370385e-08 -0.09986641617340192 -2.4062 0.7068712769420904 0.7068700598180625 5.6432403149758725e-08 -0.09986645672658562 -2.4063000000000003 0.7068713497091994 0.7068701304324799 5.703536756600236e-08 -0.0998664972674664 -2.4064 0.7068714224607384 0.7068702010189543 5.761506057487542e-08 -0.09986653779604808 -2.4065 0.7068714951964628 0.7068702715777438 5.817135554503361e-08 -0.09986657831233439 -2.4066 0.7068715679161262 0.7068703421091076 5.870413126787821e-08 -0.09986661881632902 -2.4067000000000003 0.706871640619481 0.7068704126133063 5.921327199745474e-08 -0.0998666593080357 -2.4068 0.7068717133062791 0.7068704830906016 5.969866746606545e-08 -0.09986669978745814 -2.4069000000000003 0.7068717859762702 0.7068705535412565 6.01602129276374e-08 -0.09986674025460006 -2.407 0.7068718586292038 0.7068706239655349 6.059780916639612e-08 -0.0998667807094652 -2.4071 0.7068719312648282 0.706870694363702 6.10113625072739e-08 -0.09986682115205729 -2.4072000000000005 0.7068720038828904 0.7068707647360235 6.14007848662168e-08 -0.09986686158238005 -2.4073 0.7068720764831371 0.7068708350827664 6.176599373630687e-08 -0.09986690200043717 -2.4074 0.7068721490653135 0.706870905404198 6.210691222592601e-08 -0.09986694240623237 -2.4075 0.7068722216291645 0.7068709757005867 6.242346906222551e-08 -0.09986698279976935 -2.4076 0.7068722941744348 0.7068710459722015 6.271559862061626e-08 -0.09986702318105188 -2.4077 0.7068723667008672 0.7068711162193122 6.298324091782992e-08 -0.09986706355008365 -2.4078000000000004 0.7068724392082049 0.7068711864421888 6.322634165008278e-08 -0.09986710390686832 -2.4079 0.7068725116961903 0.7068712566411022 6.344485217919804e-08 -0.09986714425140965 -2.408 0.7068725841645651 0.7068713268163236 6.363872956383076e-08 -0.09986718458371133 -2.4081 0.7068726566130712 0.7068713969681244 6.38079365351818e-08 -0.09986722490377709 -2.4082000000000003 0.7068727290414498 0.7068714670967765 6.395244154903945e-08 -0.09986726521161061 -2.4083 0.7068728014494416 0.7068715372025522 6.407221874935032e-08 -0.09986730550721562 -2.4084 0.7068728738367875 0.7068716072857242 6.416724799770956e-08 -0.09986734579059584 -2.4085 0.7068729462032282 0.7068716773465644 6.423751487509566e-08 -0.09986738606175494 -2.4086 0.7068730185485039 0.7068717473853459 6.428301065931896e-08 -0.09986742632069662 -2.4087 0.7068730908723553 0.7068718174023412 6.430373236318565e-08 -0.0998674665674246 -2.4088000000000003 0.7068731631745229 0.7068718873978226 6.429968270674213e-08 -0.09986750680194255 -2.4089 0.7068732354547473 0.7068719573720629 6.427087011033616e-08 -0.09986754702425425 -2.409 0.7068733077127691 0.7068720273253342 6.421730871716824e-08 -0.09986758723436329 -2.4091 0.7068733799483294 0.7068720972579086 6.413901836380131e-08 -0.0998676274322734 -2.4092000000000002 0.7068734521611697 0.706872167170058 6.403602459924274e-08 -0.09986766761798832 -2.4093 0.7068735243510313 0.7068722370620539 6.390835863984146e-08 -0.09986770779151172 -2.4094 0.7068735965176565 0.7068723069341676 6.375605738663526e-08 -0.09986774795284731 -2.4095 0.7068736686607875 0.7068723767866691 6.357916343402437e-08 -0.09986778810199874 -2.4095999999999997 0.7068737407801677 0.7068724466198291 6.337772501079086e-08 -0.09986782823896978 -2.4097000000000004 0.7068738128755403 0.7068725164339165 6.315179599397647e-08 -0.099867868363764 -2.4098 0.7068738849466498 0.7068725862292004 6.29014358915353e-08 -0.0998679084763852 -2.4099 0.7068739569932412 0.7068726560059488 6.262670984580332e-08 -0.09986794857683703 -2.41 0.7068740290150601 0.7068727257644292 6.232768857625248e-08 -0.0998679886651232 -2.4101 0.7068741010118531 0.7068727955049077 6.200444839510322e-08 -0.09986802874124731 -2.4102 0.7068741729833674 0.7068728652276504 6.165707116916053e-08 -0.09986806880521315 -2.4103000000000003 0.7068742449293516 0.7068729349329215 6.128564432328343e-08 -0.0998681088570243 -2.4104 0.706874316849555 0.706873004620985 6.089026077446547e-08 -0.09986814889668454 -2.4105 0.7068743887437285 0.7068730742921034 6.047101896479445e-08 -0.09986818892419752 -2.4106 0.7068744606116231 0.7068731439465381 6.002802278859409e-08 -0.0998682289395669 -2.4107000000000003 0.7068745324529917 0.7068732135845497 5.956138159242397e-08 -0.09986826894279639 -2.4108 0.7068746042675882 0.7068732832063966 5.907121014732397e-08 -0.09986830893388965 -2.4109000000000003 0.7068746760551683 0.706873352812337 5.855762861411984e-08 -0.09986834891285036 -2.411 0.7068747478154883 0.706873422402627 5.80207625104634e-08 -0.09986838887968219 -2.4111 0.7068748195483062 0.7068734919775215 5.746074269001589e-08 -0.09986842883438878 -2.4112000000000005 0.7068748912533815 0.7068735615372743 5.687770531295766e-08 -0.09986846877697382 -2.4113 0.7068749629304758 0.7068736310821371 5.627179179047703e-08 -0.09986850870744104 -2.4114 0.7068750345793513 0.7068737006123604 5.5643148777831386e-08 -0.09986854862579408 -2.4115 0.7068751061997725 0.706873770128193 5.4991928125774914e-08 -0.09986858853203663 -2.4116 0.706875177791505 0.7068738396298815 5.431828685106832e-08 -0.0998686284261723 -2.4117 0.7068752493543169 0.7068739091176716 5.36223870757635e-08 -0.09986866830820482 -2.4118000000000004 0.7068753208879774 0.7068739785918066 5.290439602720354e-08 -0.09986870817813781 -2.4119 0.706875392392258 0.706874048052528 5.216448596516432e-08 -0.09986874803597494 -2.412 0.7068754638669321 0.7068741175000759 5.140283415236424e-08 -0.09986878788171996 -2.4120999999999997 0.7068755353117747 0.7068741869346876 5.061962281109611e-08 -0.09986882771537639 -2.4122000000000003 0.7068756067265632 0.7068742563565988 4.981503909894103e-08 -0.09986886753694796 -2.4123 0.7068756781110772 0.7068743257660435 4.898927500815442e-08 -0.09986890734643841 -2.4124 0.7068757494650977 0.706874395163253 4.814252738821745e-08 -0.09986894714385129 -2.4125 0.7068758207884085 0.7068744645484565 4.7274997860835555e-08 -0.09986898692919027 -2.4126 0.7068758920807956 0.7068745339218814 4.638689277310093e-08 -0.09986902670245912 -2.4127 0.7068759633420469 0.7068746032837521 4.547842316106332e-08 -0.09986906646366134 -2.4128000000000003 0.7068760345719529 0.7068746726342914 4.454980468727998e-08 -0.09986910621280069 -2.4129 0.7068761057703064 0.7068747419737194 4.360125759918232e-08 -0.09986914594988074 -2.413 0.7068761769369027 0.7068748113022538 4.26330066787689e-08 -0.09986918567490527 -2.4131 0.7068762480715394 0.7068748806201096 4.164528117668598e-08 -0.09986922538787779 -2.4132000000000002 0.7068763191740168 0.7068749499275 4.0638314768859374e-08 -0.09986926508880206 -2.4133 0.7068763902441377 0.7068750192246349 3.961234549057502e-08 -0.09986930477768173 -2.4134 0.7068764612817076 0.7068750885117216 3.8567615698315016e-08 -0.09986934445452036 -2.4135 0.7068765322865341 0.7068751577889653 3.750437198822565e-08 -0.09986938411932167 -2.4135999999999997 0.7068766032584285 0.7068752270565681 3.642286516662707e-08 -0.09986942377208934 -2.4137000000000004 0.7068766741972038 0.7068752963147296 3.5323350168481316e-08 -0.09986946341282692 -2.4138 0.7068767451026764 0.706875365563646 3.4206086003615854e-08 -0.09986950304153808 -2.4139 0.7068768159746657 0.7068754348035116 3.307133569774301e-08 -0.09986954265822652 -2.414 0.7068768868129931 0.7068755040345167 3.191936623347935e-08 -0.09986958226289583 -2.4141 0.7068769576174838 0.7068755732568499 3.0750448474017866e-08 -0.09986962185554965 -2.4142 0.7068770283879657 0.7068756424706959 2.956485711108625e-08 -0.09986966143619164 -2.4143000000000003 0.7068770991242697 0.706875711676237 2.836287060770104e-08 -0.09986970100482544 -2.4144 0.7068771698262294 0.706875780873652 2.7144771121839772e-08 -0.09986974056145467 -2.4145 0.7068772404936818 0.7068758500631172 2.591084442664371e-08 -0.09986978010608304 -2.4146 0.7068773111264671 0.7068759192448051 2.4661379879192813e-08 -0.09986981963871411 -2.4147000000000003 0.7068773817244283 0.7068759884188853 2.3396670326830682e-08 -0.09986985915935148 -2.4148 0.7068774522874122 0.7068760575855246 2.2117012030836714e-08 -0.0998698986679989 -2.4149000000000003 0.7068775228152677 0.706876126744886 2.0822704622190658e-08 -0.0998699381646599 -2.415 0.7068775933078483 0.7068761958971295 1.951405102351006e-08 -0.09986997764933819 -2.4151 0.7068776637650098 0.706876265042412 1.8191357364916172e-08 -0.09987001712203734 -2.4152000000000005 0.7068777341866118 0.7068763341808868 1.685493292158391e-08 -0.099870056582761 -2.4153000000000002 0.706877804572517 0.7068764033127037 1.5505090047822356e-08 -0.09987009603151281 -2.4154 0.7068778749225919 0.7068764724380097 1.4142144092073317e-08 -0.09987013546829639 -2.4155 0.706877945236706 0.7068765415569476 1.2766413336195992e-08 -0.09987017489311535 -2.4156 0.7068780155147323 0.7068766106696573 1.1378218908730808e-08 -0.09987021430597333 -2.4157 0.7068780857565476 0.706876679776275 9.977884714643115e-09 -0.09987025370687398 -2.4158000000000004 0.706878155962032 0.7068767488769336 8.565737365066883e-09 -0.09987029309582092 -2.4159 0.7068782261310687 0.7068768179717622 7.142106091435896e-09 -0.0998703324728177 -2.416 0.7068782962635451 0.7068768870608864 5.707322676094806e-09 -0.099870371837868 -2.4160999999999997 0.7068783663593523 0.7068769561444282 4.261721375971306e-09 -0.09987041119097544 -2.4162000000000003 0.7068784364183844 0.7068770252225063 2.8056388410441224e-09 -0.09987045053214363 -2.4163 0.7068785064405396 0.706877094295235 1.339414029341568e-09 -0.09987048986137621 -2.4164 0.7068785764257197 0.7068771633627257 -1.3661185550850607e-10 -0.09987052917867678 -2.4165 0.7068786463738297 0.7068772324250855 -1.6220954588211378e-09 -0.09987056848404892 -2.4166 0.7068787162847789 0.7068773014824183 -3.1166913477126412e-09 -0.09987060777749626 -2.4167 0.7068787861584804 0.7068773705348241 -4.620052092632609e-09 -0.09987064705902243 -2.4168000000000003 0.7068788559948503 0.706877439582399 -6.131828342824386e-09 -0.09987068632863103 -2.4169 0.7068789257938095 0.7068775086252354 -7.651668917398047e-09 -0.09987072558632568 -2.417 0.7068789955552817 0.706877577663422 -9.179220882525596e-09 -0.09987076483210999 -2.4171 0.7068790652791953 0.7068776466970434 -1.0714129626901436e-08 -0.09987080406598758 -2.4172000000000002 0.7068791349654819 0.706877715726181 -1.2256038958886883e-08 -0.09987084328796204 -2.4173 0.706879204614077 0.7068777847509115 -1.3804591172429659e-08 -0.099870882498037 -2.4174 0.7068792742249201 0.7068778537713083 -1.5359427140305276e-08 -0.09987092169621599 -2.4175 0.7068793437979548 0.7068779227874407 -1.6920186395649045e-08 -0.09987096088250269 -2.4175999999999997 0.7068794133331284 0.7068779917993745 -1.8486507214355435e-08 -0.09987100005690074 -2.4177000000000004 0.7068794828303919 0.706878060807171 -2.0058026698778486e-08 -0.09987103921941363 -2.4178 0.7068795522897005 0.7068781298108878 -2.1634380862299574e-08 -0.09987107837004502 -2.4179 0.7068796217110128 0.706878198810579 -2.321520471302782e-08 -0.09987111750879851 -2.418 0.7068796910942922 0.7068782678062944 -2.4800132339235226e-08 -0.09987115663567775 -2.4181 0.7068797604395052 0.7068783367980795 -2.6388796993057073e-08 -0.09987119575068623 -2.4182 0.7068798297466226 0.7068784057859767 -2.7980831176794424e-08 -0.0998712348538276 -2.4183000000000003 0.7068798990156191 0.7068784747700236 -2.9575866725747163e-08 -0.09987127394510543 -2.4184 0.7068799682464737 0.7068785437502548 -3.117353489321545e-08 -0.0998713130245234 -2.4185 0.706880037439169 0.7068786127266997 -3.2773466440271654e-08 -0.09987135209208503 -2.4186 0.7068801065936916 0.7068786816993851 -3.437529171555764e-08 -0.09987139114779396 -2.4187000000000003 0.706880175710032 0.7068787506683321 -3.597864074299673e-08 -0.0998714301916537 -2.4188 0.7068802447881848 0.7068788196335596 -3.758314330668672e-08 -0.09987146922366791 -2.4189000000000003 0.7068803138281488 0.7068788885950814 -3.9188429037852884e-08 -0.09987150824384015 -2.419 0.7068803828299262 0.7068789575529077 -4.0794127498440004e-08 -0.09987154725217401 -2.4191 0.7068804517935239 0.706879026507045 -4.2399868267116664e-08 -0.0998715862486731 -2.4192000000000005 0.706880520718952 0.706879095457495 -4.4005281023578766e-08 -0.09987162523334098 -2.4193000000000002 0.7068805896062251 0.7068791644042564 -4.560999563842311e-08 -0.09987166420618122 -2.4194 0.7068806584553617 0.7068792333473232 -4.7213642252741383e-08 -0.09987170316719746 -2.4195 0.7068807272663842 0.7068793022866856 -4.8815851366604615e-08 -0.09987174211639323 -2.4196 0.7068807960393189 0.7068793712223302 -5.041625392252641e-08 -0.09987178105377216 -2.4197 0.7068808647741962 0.7068794401542391 -5.201448139335787e-08 -0.0998718199793378 -2.4198000000000004 0.7068809334710504 0.7068795090823909 -5.361016586257275e-08 -0.09987185889309373 -2.4199 0.7068810021299194 0.7068795780067598 -5.520294011165418e-08 -0.09987189779504352 -2.42 0.7068810707508459 0.7068796469273166 -5.6792437706830803e-08 -0.09987193668519076 -2.4200999999999997 0.7068811393338754 0.7068797158440278 -5.837829307833199e-08 -0.09987197556353902 -2.4202000000000004 0.7068812078790583 0.7068797847568561 -5.996014160636505e-08 -0.09987201443009192 -2.4203 0.7068812763864479 0.7068798536657602 -6.153761970958613e-08 -0.09987205328485295 -2.4204 0.7068813448561027 0.7068799225706953 -6.311036491969332e-08 -0.09987209212782577 -2.4205 0.7068814132880836 0.706879991471612 -6.467801597163231e-08 -0.09987213095901387 -2.4206 0.7068814816824566 0.7068800603684575 -6.624021288512832e-08 -0.09987216977842087 -2.4207 0.7068815500392909 0.7068801292611753 -6.779659704686872e-08 -0.09987220858605034 -2.4208000000000003 0.7068816183586597 0.7068801981497046 -6.934681128639708e-08 -0.09987224738190582 -2.4209 0.70688168664064 0.7068802670339815 -7.089049997412514e-08 -0.09987228616599092 -2.421 0.7068817548853126 0.7068803359139373 -7.24273090855175e-08 -0.09987232493830916 -2.4211 0.706881823092762 0.7068804047895003 -7.395688629433309e-08 -0.09987236369886417 -2.4212000000000002 0.7068818912630765 0.7068804736605947 -7.547888104374872e-08 -0.09987240244765944 -2.4213 0.7068819593963482 0.706880542527141 -7.699294463699852e-08 -0.09987244118469851 -2.4214 0.706882027492673 0.7068806113890564 -7.849873030849747e-08 -0.09987247990998507 -2.4215 0.7068820955521503 0.7068806802462535 -7.999589330710821e-08 -0.09987251862352259 -2.4215999999999998 0.7068821635748832 0.706880749098642 -8.148409097550463e-08 -0.0998725573253146 -2.4217000000000004 0.7068822315609786 0.7068808179461279 -8.29629828256323e-08 -0.09987259601536475 -2.4218 0.706882299510547 0.7068808867886129 -8.443223062024052e-08 -0.09987263469367658 -2.4219 0.7068823674237021 0.7068809556259958 -8.589149844660804e-08 -0.09987267336025356 -2.422 0.706882435300562 0.7068810244581716 -8.734045279807506e-08 -0.09987271201509931 -2.4221 0.7068825031412478 0.7068810932850316 -8.877876264603429e-08 -0.09987275065821744 -2.4222 0.7068825709458839 0.7068811621064639 -9.020609951539138e-08 -0.09987278928961141 -2.4223000000000003 0.7068826387145987 0.7068812309223527 -9.162213756089277e-08 -0.09987282790928484 -2.4224 0.7068827064475236 0.7068812997325788 -9.302655364258616e-08 -0.09987286651724123 -2.4225 0.7068827741447941 0.7068813685370199 -9.441902740214836e-08 -0.09987290511348414 -2.4226 0.7068828418065485 0.7068814373355501 -9.579924132793738e-08 -0.09987294369801716 -2.4227000000000003 0.7068829094329283 0.7068815061280401 -9.716688082785085e-08 -0.09987298227084382 -2.4228 0.706882977024079 0.7068815749143571 -9.852163431432748e-08 -0.09987302083196758 -2.4229000000000003 0.7068830445801491 0.7068816436943652 -9.986319326159288e-08 -0.0998730593813921 -2.423 0.7068831121012904 0.7068817124679255 -1.0119125227418119e-07 -0.09987309791912093 -2.4231 0.706883179587658 0.7068817812348952 -1.025055091675997e-07 -0.09987313644515754 -2.4232000000000005 0.7068832470394095 0.7068818499951286 -1.0380566503685046e-07 -0.09987317495950546 -2.4233000000000002 0.7068833144567072 0.7068819187484768 -1.0509142431020663e-07 -0.09987321346216828 -2.4234 0.7068833818397149 0.7068819874947883 -1.0636249483247928e-07 -0.09987325195314956 -2.4235 0.7068834491886007 0.7068820562339075 -1.0761858791792644e-07 -0.09987329043245283 -2.4236 0.7068835165035349 0.7068821249656765 -1.0885941842397884e-07 -0.09987332890008156 -2.4237 0.7068835837846913 0.7068821936899341 -1.1008470482062882e-07 -0.09987336735603941 -2.4238000000000004 0.7068836510322467 0.7068822624065163 -1.1129416924160473e-07 -0.09987340580032981 -2.4239 0.7068837182463804 0.7068823311152559 -1.1248753755375984e-07 -0.09987344423295634 -2.424 0.7068837854272751 0.706882399815983 -1.136645394143182e-07 -0.09987348265392254 -2.4240999999999997 0.7068838525751161 0.7068824685085245 -1.1482490835414139e-07 -0.09987352106323193 -2.4242000000000004 0.7068839196900916 0.7068825371927052 -1.1596838179854518e-07 -0.09987355946088802 -2.4243 0.706883986772392 0.7068826058683464 -1.1709470116097465e-07 -0.09987359784689435 -2.4244 0.7068840538222114 0.706882674535267 -1.1820361188810691e-07 -0.09987363622125447 -2.4245 0.7068841208397465 0.7068827431932831 -1.1929486351709706e-07 -0.09987367458397192 -2.4246 0.7068841878251957 0.7068828118422085 -1.2036820973282403e-07 -0.09987371293505024 -2.4247 0.7068842547787606 0.7068828804818538 -1.2142340841993227e-07 -0.09987375127449288 -2.4248000000000003 0.7068843217006452 0.7068829491120274 -1.2246022173048599e-07 -0.09987378960230338 -2.4249 0.7068843885910565 0.7068830177325355 -1.234784161256025e-07 -0.09987382791848534 -2.425 0.7068844554502034 0.7068830863431812 -1.244777624222898e-07 -0.09987386622304224 -2.4251 0.7068845222782971 0.7068831549437657 -1.2545803586977433e-07 -0.09987390451597761 -2.4252000000000002 0.7068845890755517 0.7068832235340878 -1.264190161633788e-07 -0.09987394279729495 -2.4253 0.7068846558421833 0.7068832921139436 -1.2736048753299312e-07 -0.09987398106699781 -2.4254000000000002 0.7068847225784102 0.7068833606831272 -1.2828223876909517e-07 -0.09987401932508971 -2.4255 0.7068847892844528 0.7068834292414307 -1.2918406326438425e-07 -0.09987405757157415 -2.4255999999999998 0.706884855960534 0.7068834977886436 -1.3006575907276163e-07 -0.09987409580645464 -2.4257000000000004 0.7068849226068787 0.7068835663245536 -1.3092712896137226e-07 -0.09987413402973473 -2.4258 0.7068849892237139 0.706883634848946 -1.317679804348909e-07 -0.09987417224141792 -2.4259 0.7068850558112684 0.7068837033616047 -1.3258812578756385e-07 -0.09987421044150772 -2.426 0.706885122369773 0.7068837718623108 -1.3338738214657697e-07 -0.0998742486300076 -2.4261 0.7068851888994603 0.7068838403508442 -1.341655715188933e-07 -0.09987428680692112 -2.4262 0.7068852554005651 0.7068839088269827 -1.3492252081206968e-07 -0.09987432497225174 -2.4263000000000003 0.706885321873324 0.7068839772905025 -1.3565806190017626e-07 -0.09987436312600306 -2.4264 0.7068853883179751 0.7068840457411777 -1.3637203162726597e-07 -0.09987440126817854 -2.4265 0.706885454734758 0.7068841141787807 -1.370642718698245e-07 -0.09987443939878168 -2.4266 0.7068855211239142 0.706884182603083 -1.3773462956799543e-07 -0.099874477517816 -2.4267000000000003 0.706885587485687 0.7068842510138531 -1.383829567550704e-07 -0.09987451562528497 -2.4268 0.706885653820321 0.7068843194108596 -1.3900911057483645e-07 -0.09987455372119215 -2.4269000000000003 0.706885720128062 0.7068843877938683 -1.3961295333708712e-07 -0.09987459180554102 -2.427 0.7068857864091576 0.7068844561626444 -1.4019435254711277e-07 -0.09987462987833506 -2.4271 0.7068858526638566 0.7068845245169517 -1.4075318091957834e-07 -0.09987466793957783 -2.4272000000000005 0.7068859188924093 0.7068845928565521 -1.4128931640627895e-07 -0.0998747059892728 -2.4273000000000002 0.7068859850950668 0.7068846611812067 -1.4180264223777328e-07 -0.09987474402742347 -2.4274 0.7068860512720816 0.7068847294906753 -1.4229304693552658e-07 -0.09987478205403327 -2.4275 0.7068861174237077 0.7068847977847168 -1.4276042433793157e-07 -0.09987482006910581 -2.4276 0.7068861835501994 0.7068848660630886 -1.432046736436765e-07 -0.0998748580726445 -2.4277 0.7068862496518127 0.7068849343255474 -1.4362569939613268e-07 -0.09987489606465286 -2.4278000000000004 0.7068863157288046 0.706885002571849 -1.440234115284572e-07 -0.09987493404513441 -2.4279 0.7068863817814321 0.706885070801748 -1.4439772537573614e-07 -0.09987497201409261 -2.428 0.7068864478099545 0.7068851390149982 -1.4474856170967887e-07 -0.09987500997153098 -2.4280999999999997 0.7068865138146303 0.7068852072113527 -1.4507584671606677e-07 -0.09987504791745301 -2.4282000000000004 0.7068865797957199 0.7068852753905642 -1.4537951205026434e-07 -0.09987508585186217 -2.4283 0.7068866457534836 0.7068853435523843 -1.4565949484068863e-07 -0.09987512377476196 -2.4284 0.706886711688183 0.7068854116965638 -1.459157376836051e-07 -0.09987516168615586 -2.4285 0.7068867776000793 0.7068854798228538 -1.4614818866567902e-07 -0.09987519958604738 -2.4286 0.7068868434894354 0.7068855479310039 -1.4635680138652685e-07 -0.09987523747443995 -2.4287 0.7068869093565135 0.7068856160207639 -1.4654153495871625e-07 -0.09987527535133708 -2.4288000000000003 0.7068869752015772 0.7068856840918833 -1.4670235399735776e-07 -0.09987531321674233 -2.4289 0.7068870410248893 0.7068857521441108 -1.4683922866867705e-07 -0.09987535107065906 -2.429 0.7068871068267137 0.7068858201771949 -1.4695213464317736e-07 -0.0998753889130908 -2.4291 0.7068871726073143 0.7068858881908846 -1.4704105314768123e-07 -0.09987542674404107 -2.4292000000000002 0.7068872383669549 0.7068859561849278 -1.4710597093237077e-07 -0.0998754645635133 -2.4293 0.7068873041058994 0.7068860241590731 -1.4714688030374734e-07 -0.09987550237151097 -2.4294000000000002 0.706887369824412 0.7068860921130686 -1.4716377908126355e-07 -0.09987554016803757 -2.4295 0.706887435522757 0.7068861600466628 -1.47156670642426e-07 -0.09987557795309661 -2.4295999999999998 0.7068875012011978 0.7068862279596042 -1.4712556389677445e-07 -0.09987561572669154 -2.4297000000000004 0.7068875668599981 0.7068862958516411 -1.4707047328067768e-07 -0.0998756534888258 -2.4298 0.7068876324994215 0.7068863637225224 -1.4699141876427235e-07 -0.09987569123950288 -2.4299 0.7068876981197314 0.7068864315719972 -1.4688842583064632e-07 -0.09987572897872624 -2.43 0.7068877637211903 0.706886499399815 -1.4676152548798171e-07 -0.0998757667064994 -2.4301 0.706887829304061 0.7068865672057256 -1.4661075423312575e-07 -0.0998758044228258 -2.4302 0.7068878948686054 0.7068866349894793 -1.4643615406199906e-07 -0.09987584212770893 -2.4303000000000003 0.7068879604150846 0.706886702750827 -1.4623777245745262e-07 -0.0998758798211522 -2.4304 0.7068880259437599 0.7068867704895199 -1.4601566236671637e-07 -0.09987591750315913 -2.4305 0.7068880914548914 0.70688683820531 -1.457698822013992e-07 -0.09987595517373316 -2.4306 0.7068881569487389 0.70688690589795 -1.4550049580799862e-07 -0.09987599283287779 -2.4307000000000003 0.7068882224255606 0.7068869735671938 -1.4520757246096194e-07 -0.09987603048059644 -2.4308 0.7068882878856153 0.706887041212795 -1.4489118683493063e-07 -0.09987606811689258 -2.4309000000000003 0.7068883533291592 0.7068871088345092 -1.4455141900820978e-07 -0.09987610574176968 -2.431 0.7068884187564493 0.7068871764320925 -1.4418835440725697e-07 -0.0998761433552312 -2.4311 0.7068884841677405 0.7068872440053018 -1.4380208382229476e-07 -0.09987618095728065 -2.4312000000000005 0.7068885495632868 0.706887311553895 -1.4339270335179954e-07 -0.0998762185479214 -2.4313000000000002 0.7068886149433413 0.7068873790776313 -1.4296031441117518e-07 -0.09987625612715692 -2.4314 0.7068886803081561 0.7068874465762711 -1.42505023682446e-07 -0.09987629369499071 -2.4315 0.7068887456579815 0.7068875140495763 -1.4202694309690955e-07 -0.0998763312514262 -2.4316 0.7068888109930673 0.7068875814973092 -1.4152618981778942e-07 -0.09987636879646682 -2.4317 0.7068888763136616 0.7068876489192344 -1.4100288618298928e-07 -0.0998764063301161 -2.4318 0.7068889416200111 0.7068877163151173 -1.404571597068277e-07 -0.09987644385237748 -2.4319 0.706889006912361 0.7068877836847243 -1.3988914303667e-07 -0.09987648136325433 -2.432 0.7068890721909549 0.7068878510278243 -1.3929897390956014e-07 -0.09987651886275015 -2.4320999999999997 0.7068891374560355 0.7068879183441874 -1.3868679514701665e-07 -0.09987655635086844 -2.4322000000000004 0.706889202707843 0.7068879856335848 -1.380527545873783e-07 -0.09987659382761255 -2.4323 0.7068892679466164 0.7068880528957899 -1.373970050771306e-07 -0.09987663129298598 -2.4324 0.7068893331725934 0.7068881201305774 -1.3671970441019032e-07 -0.09987666874699215 -2.4325 0.7068893983860092 0.7068881873377242 -1.3602101531923205e-07 -0.09987670618963454 -2.4326 0.7068894635870975 0.7068882545170087 -1.3530110540976859e-07 -0.09987674362091654 -2.4327 0.7068895287760903 0.706888321668211 -1.3456014712892594e-07 -0.09987678104084165 -2.4328000000000003 0.7068895939532176 0.7068883887911139 -1.337983177307489e-07 -0.09987681844941332 -2.4329 0.7068896591187073 0.7068884558855009 -1.330157992328329e-07 -0.09987685584663492 -2.433 0.7068897242727853 0.7068885229511587 -1.3221277836254763e-07 -0.09987689323250992 -2.4331 0.7068897894156756 0.7068885899878754 -1.3138944651540363e-07 -0.09987693060704181 -2.4332000000000003 0.7068898545475999 0.7068886569954415 -1.3054599972209258e-07 -0.09987696797023399 -2.4333 0.706889919668778 0.7068887239736492 -1.2968263859297613e-07 -0.09987700532208985 -2.4334000000000002 0.7068899847794272 0.7068887909222936 -1.2879956826084005e-07 -0.0998770426626129 -2.4335 0.7068900498797626 0.7068888578411714 -1.2789699834793444e-07 -0.09987707999180646 -2.4335999999999998 0.706890114969997 0.7068889247300821 -1.2697514291046264e-07 -0.09987711730967412 -2.4337000000000004 0.7068901800503411 0.7068889915888275 -1.260342203900089e-07 -0.09987715461621921 -2.4338 0.7068902451210026 0.7068890584172114 -1.2507445354761892e-07 -0.09987719191144517 -2.4339 0.7068903101821874 0.7068891252150404 -1.2409606944298324e-07 -0.09987722919535544 -2.434 0.7068903752340989 0.7068891919821236 -1.2309929933382313e-07 -0.09987726646795349 -2.4341 0.7068904402769376 0.7068892587182722 -1.2208437867762545e-07 -0.0998773037292427 -2.4342 0.7068905053109013 0.7068893254233007 -1.210515470310286e-07 -0.09987734097922651 -2.4343000000000004 0.7068905703361852 0.7068893920970257 -1.2000104800298506e-07 -0.09987737821790835 -2.4344 0.7068906353529826 0.7068894587392667 -1.1893312920792376e-07 -0.09987741544529168 -2.4345 0.7068907003614833 0.7068895253498453 -1.1784804221023903e-07 -0.09987745266137985 -2.4346 0.7068907653618741 0.7068895919285868 -1.1674604245837106e-07 -0.0998774898661763 -2.4347000000000003 0.7068908303543402 0.7068896584753187 -1.1562738920674331e-07 -0.09987752705968449 -2.4348 0.7068908953390629 0.7068897249898716 -1.144923454862723e-07 -0.0998775642419078 -2.4349000000000003 0.7068909603162208 0.7068897914720784 -1.1334117802977439e-07 -0.09987760141284963 -2.435 0.7068910252859903 0.7068898579217759 -1.1217415719737278e-07 -0.09987763857251354 -2.4351 0.7068910902485439 0.7068899243388032 -1.109915569296599e-07 -0.0998776757209028 -2.4352000000000005 0.7068911552040514 0.7068899907230022 -1.0979365468351265e-07 -0.09987771285802087 -2.4353000000000002 0.70689122015268 0.7068900570742179 -1.0858073135056046e-07 -0.09987774998387115 -2.4354 0.7068912850945936 0.7068901233922992 -1.073530712068782e-07 -0.0998777870984571 -2.4355 0.7068913500299527 0.7068901896770972 -1.0611096183232166e-07 -0.09987782420178214 -2.4356 0.7068914149589149 0.7068902559284658 -1.0485469406889408e-07 -0.09987786129384958 -2.4357 0.7068914798816348 0.7068903221462635 -1.0358456192099963e-07 -0.09987789837466295 -2.4358 0.7068915447982638 0.7068903883303506 -1.0230086251034054e-07 -0.09987793544422562 -2.4359 0.7068916097089493 0.7068904544805912 -1.0100389599351778e-07 -0.09987797250254095 -2.436 0.7068916746138367 0.7068905205968528 -9.969396549177473e-08 -0.0998780095496124 -2.4360999999999997 0.7068917395130674 0.7068905866790057 -9.837137703375132e-08 -0.0998780465854434 -2.4362000000000004 0.7068918044067791 0.7068906527269241 -9.703643947048257e-08 -0.0998780836100373 -2.4363 0.706891869295107 0.7068907187404851 -9.568946440514231e-08 -0.09987812062339751 -2.4364 0.7068919341781823 0.7068907847195695 -9.433076612885838e-08 -0.0998781576255275 -2.4365 0.7068919990561331 0.7068908506640611 -9.296066153310911e-08 -0.09987819461643058 -2.4366 0.7068920639290839 0.7068909165738475 -9.157947004814065e-08 -0.0998782315961102 -2.4367 0.7068921287971559 0.7068909824488196 -9.018751356924121e-08 -0.09987826856456977 -2.4368000000000003 0.7068921936604666 0.7068910482888721 -8.878511636827013e-08 -0.09987830552181269 -2.4369 0.7068922585191302 0.7068911140939025 -8.737260503294264e-08 -0.0998783424678423 -2.437 0.7068923233732571 0.7068911798638127 -8.59503083800936e-08 -0.09987837940266209 -2.4371 0.7068923882229543 0.7068912455985075 -8.451855738975805e-08 -0.09987841632627542 -2.4372000000000003 0.7068924530683254 0.7068913112978955 -8.307768511670033e-08 -0.09987845323868566 -2.4373 0.7068925179094702 0.7068913769618892 -8.162802662102508e-08 -0.09987849013989625 -2.4374000000000002 0.7068925827464846 0.7068914425904038 -8.016991888664532e-08 -0.09987852702991054 -2.4375 0.7068926475794612 0.7068915081833594 -7.870370074408717e-08 -0.09987856390873195 -2.4375999999999998 0.7068927124084892 0.7068915737406788 -7.722971279676416e-08 -0.09987860077636382 -2.4377000000000004 0.7068927772336535 0.7068916392622888 -7.57482973307716e-08 -0.09987863763280963 -2.4378 0.7068928420550358 0.7068917047481202 -7.425979824072712e-08 -0.09987867447807271 -2.4379 0.7068929068727137 0.7068917701981068 -7.276456095734601e-08 -0.09987871131215643 -2.438 0.7068929716867615 0.7068918356121867 -7.126293235419981e-08 -0.09987874813506425 -2.4381 0.7068930364972492 0.7068919009903015 -6.975526067745999e-08 -0.09987878494679951 -2.4382 0.7068931013042435 0.7068919663323968 -6.82418954617639e-08 -0.09987882174736556 -2.4383000000000004 0.7068931661078074 0.7068920316384217 -6.67231874473817e-08 -0.09987885853676587 -2.4384 0.7068932309079995 0.7068920969083294 -6.519948850302118e-08 -0.09987889531500378 -2.4385 0.7068932957048752 0.7068921621420765 -6.367115153909156e-08 -0.0998789320820827 -2.4386 0.706893360498486 0.7068922273396234 -6.2138530430942e-08 -0.09987896883800593 -2.4387000000000003 0.7068934252888794 0.7068922925009347 -6.06019799351612e-08 -0.09987900558277696 -2.4388 0.706893490076099 0.7068923576259785 -5.906185560414223e-08 -0.09987904231639906 -2.4389000000000003 0.7068935548601853 0.7068924227147266 -5.751851370997159e-08 -0.0998790790388757 -2.439 0.7068936196411737 0.7068924877671554 -5.59723111572593e-08 -0.09987911575021025 -2.4391 0.706893684419097 0.7068925527832441 -5.4423605402257463e-08 -0.09987915245040602 -2.4392000000000005 0.7068937491939833 0.7068926177629766 -5.2872754373279804e-08 -0.09987918913946647 -2.4393000000000002 0.7068938139658572 0.70689268270634 -5.1320116382664455e-08 -0.0998792258173949 -2.4394 0.7068938787347394 0.7068927476133257 -4.97660500460009e-08 -0.09987926248419472 -2.4395 0.7068939435006467 0.7068928124839284 -4.8210914199839014e-08 -0.09987929913986926 -2.4396 0.7068940082635924 0.7068928773181478 -4.665506782145813e-08 -0.09987933578442196 -2.4397 0.7068940730235853 0.7068929421159862 -4.50988699402877e-08 -0.09987937241785617 -2.4398 0.706894137780631 0.7068930068774502 -4.3542679559221325e-08 -0.09987940904017527 -2.4399 0.7068942025347308 0.7068930716025502 -4.19868555711874e-08 -0.09987944565138256 -2.44 0.7068942672858822 0.7068931362913009 -4.0431756675719755e-08 -0.09987948225148147 -2.4400999999999997 0.7068943320340789 0.7068932009437202 -3.887774129669383e-08 -0.09987951884047536 -2.4402000000000004 0.7068943967793109 0.7068932655598303 -3.732516749995439e-08 -0.09987955541836757 -2.4403 0.706894461521564 0.706893330139657 -3.577439291069934e-08 -0.09987959198516144 -2.4404 0.7068945262608206 0.7068933946832302 -3.422577462945404e-08 -0.09987962854086042 -2.4405 0.7068945909970589 0.7068934591905831 -3.2679669152409566e-08 -0.09987966508546779 -2.4406 0.7068946557302537 0.7068935236617534 -3.113643228837282e-08 -0.09987970161898696 -2.4407 0.7068947204603754 0.706893588096782 -2.959641907810187e-08 -0.09987973814142126 -2.4408000000000003 0.7068947851873912 0.7068936524957141 -2.8059983709846636e-08 -0.09987977465277409 -2.4409 0.7068948499112642 0.7068937168585983 -2.6527479439226315e-08 -0.09987981115304877 -2.441 0.7068949146319536 0.7068937811854872 -2.499925851008264e-08 -0.09987984764224869 -2.4411 0.706894979349415 0.7068938454764372 -2.3475672070345788e-08 -0.09987988412037718 -2.4412000000000003 0.7068950440636005 0.706893909731508 -2.1957070093971826e-08 -0.0998799205874376 -2.4413 0.7068951087744577 0.7068939739507636 -2.044380129854334e-08 -0.09987995704343328 -2.4414000000000002 0.7068951734819313 0.7068940381342717 -1.8936213065038482e-08 -0.09987999348836762 -2.4415 0.7068952381859619 0.7068941022821034 -1.7434651364972575e-08 -0.09988002992224394 -2.4415999999999998 0.7068953028864865 0.7068941663943334 -1.5939460665855693e-08 -0.09988006634506563 -2.4417000000000004 0.7068953675834381 0.7068942304710408 -1.4450983871344691e-08 -0.09988010275683601 -2.4418 0.7068954322767462 0.7068942945123078 -1.296956222843551e-08 -0.09988013915755843 -2.4419 0.7068954969663372 0.7068943585182198 -1.1495535251569017e-08 -0.09988017554723626 -2.442 0.7068955616521329 0.7068944224888669 -1.00292406502063e-08 -0.09988021192587278 -2.4421 0.7068956263340525 0.7068944864243418 -8.57101424642931e-09 -0.09988024829347142 -2.4422 0.7068956910120107 0.7068945503247416 -7.121189903383507e-09 -0.09988028465003551 -2.4423000000000004 0.706895755685919 0.7068946141901664 -5.680099443745867e-09 -0.09988032099556832 -2.4424 0.7068958203556859 0.7068946780207199 -4.248072572529682e-09 -0.09988035733007325 -2.4425 0.7068958850212155 0.7068947418165095 -2.8254368063945767e-09 -0.09988039365355365 -2.4426 0.706895949682409 0.7068948055776463 -1.4125174016554887e-09 -0.09988042996601285 -2.4427000000000003 0.706896014339164 0.7068948693042443 -9.637268413853484e-12 -0.09988046626745423 -2.4428 0.7068960789913746 0.706894932996421 1.3828830910250778e-09 -0.09988050255788106 -2.4429000000000003 0.7068961436389314 0.7068949966542977 2.764725663684242e-09 -0.09988053883729667 -2.443 0.7068962082817215 0.7068950602779991 4.13557499356898e-09 -0.09988057510570444 -2.4431 0.7068962729196292 0.7068951238676529 5.495118259729592e-09 -0.0998806113631077 -2.4432000000000005 0.706896337552535 0.7068951874233902 6.843045335241937e-09 -0.09988064760950979 -2.4433000000000002 0.7068964021803161 0.7068952509453457 8.179048871341521e-09 -0.09988068384491403 -2.4434 0.706896466802847 0.7068953144336569 9.502824362475626e-09 -0.0998807200693238 -2.4435 0.706896531419998 0.7068953778884652 1.0814070209620719e-08 -0.09988075628274236 -2.4436 0.7068965960316369 0.7068954413099141 1.2112487808753347e-08 -0.09988079248517306 -2.4437 0.7068966606376283 0.7068955046981515 1.339778159074878e-08 -0.09988082867661928 -2.4438 0.7068967252378335 0.7068955680533278 1.4669659105515098e-08 -0.09988086485708432 -2.4439 0.7068967898321104 0.7068956313755961 1.592783108704532e-08 -0.09988090102657149 -2.444 0.7068968544203142 0.7068956946651135 1.7172011519336894e-08 -0.09988093718508408 -2.4440999999999997 0.7068969190022973 0.7068957579220397 1.8401917696239667e-08 -0.09988097333262552 -2.4442000000000004 0.7068969835779086 0.7068958211465373 1.9617270293446898e-08 -0.09988100946919906 -2.4443 0.7068970481469943 0.7068958843387716 2.081779342227169e-08 -0.09988104559480804 -2.4444 0.7068971127093975 0.7068959474989114 2.200321470684219e-08 -0.09988108170945575 -2.4445 0.7068971772649586 0.7068960106271283 2.3173265320530767e-08 -0.0998811178131456 -2.4446 0.7068972418135153 0.7068960737235961 2.432768008049646e-08 -0.09988115390588084 -2.4447 0.7068973063549024 0.7068961367884921 2.546619747890999e-08 -0.0998811899876648 -2.4448000000000003 0.7068973708889514 0.706896199821996 2.658855975667951e-08 -0.09988122605850082 -2.4449 0.7068974354154919 0.7068962628242905 2.769451296069647e-08 -0.09988126211839221 -2.445 0.70689749993435 0.7068963257955608 2.878380700108152e-08 -0.09988129816734226 -2.4451 0.7068975644453499 0.7068963887359945 2.985619569108311e-08 -0.09988133420535428 -2.4452000000000003 0.7068976289483131 0.7068964516457825 3.091143683034425e-08 -0.09988137023243168 -2.4453 0.7068976934430579 0.7068965145251175 3.1949292251740036e-08 -0.09988140624857769 -2.4454000000000002 0.7068977579294007 0.7068965773741949 3.296952786127627e-08 -0.09988144225379564 -2.4455 0.7068978224071554 0.7068966401932126 3.397191368839647e-08 -0.09988147824808884 -2.4455999999999998 0.7068978868761331 0.7068967029823714 3.4956223972718026e-08 -0.09988151423146058 -2.4457000000000004 0.7068979513361429 0.7068967657418735 3.592223716923637e-08 -0.09988155020391419 -2.4458 0.7068980157869915 0.7068968284719244 3.686973603332644e-08 -0.099881586165453 -2.4459 0.7068980802284832 0.7068968911727312 3.779850765543713e-08 -0.09988162211608029 -2.446 0.7068981446604201 0.7068969538445036 3.870834350098995e-08 -0.09988165805579935 -2.4461 0.7068982090826024 0.7068970164874533 3.959903947109433e-08 -0.09988169398461355 -2.4462 0.7068982734948275 0.7068970791017941 4.0470395940711557e-08 -0.09988172990252614 -2.4463000000000004 0.7068983378968914 0.7068971416877422 4.132221781243117e-08 -0.09988176580954042 -2.4464 0.7068984022885877 0.7068972042455153 4.215431453902241e-08 -0.09988180170565972 -2.4465 0.7068984666697082 0.7068972667753337 4.296650019455783e-08 -0.09988183759088737 -2.4466 0.7068985310400425 0.7068973292774194 4.375859349696476e-08 -0.09988187346522664 -2.4467000000000003 0.7068985953993785 0.706897391751996 4.453041784618916e-08 -0.09988190932868081 -2.4468 0.7068986597475021 0.7068974541992892 4.528180137797211e-08 -0.09988194518125319 -2.4469000000000003 0.7068987240841977 0.7068975166195265 4.601257698813588e-08 -0.0998819810229471 -2.447 0.7068987884092478 0.7068975790129369 4.672258238115623e-08 -0.0998820168537658 -2.4471 0.706898852722433 0.7068976413797515 4.741166010138742e-08 -0.0998820526737126 -2.4472000000000005 0.7068989170235327 0.7068977037202026 4.807965756081778e-08 -0.09988208848279079 -2.4473000000000003 0.7068989813123243 0.7068977660345244 4.872642708417252e-08 -0.09988212428100368 -2.4474 0.706899045588584 0.7068978283229523 4.935182593840404e-08 -0.09988216006835454 -2.4475 0.7068991098520863 0.7068978905857237 4.9955716353508595e-08 -0.0998821958448467 -2.4476 0.7068991741026045 0.7068979528230771 5.053796556762913e-08 -0.09988223161048346 -2.4477 0.7068992383399102 0.7068980150352517 5.109844585828027e-08 -0.09988226736526801 -2.4478 0.706899302563774 0.7068980772224893 5.163703454755253e-08 -0.09988230310920372 -2.4479 0.7068993667739651 0.706898139385032 5.215361405068453e-08 -0.09988233884229386 -2.448 0.7068994309702519 0.7068982015231235 5.264807189167553e-08 -0.09988237456454177 -2.4480999999999997 0.7068994951524008 0.7068982636370086 5.312030073797991e-08 -0.09988241027595067 -2.4482000000000004 0.7068995593201779 0.7068983257269328 5.3570198402241864e-08 -0.09988244597652385 -2.4483 0.706899623473348 0.7068983877931432 5.399766788739824e-08 -0.0998824816662646 -2.4484 0.7068996876116747 0.7068984498358877 5.4402617409229914e-08 -0.09988251734517622 -2.4485 0.7068997517349208 0.7068985118554147 5.4784960385953485e-08 -0.09988255301326196 -2.4486 0.7068998158428486 0.7068985738519744 5.5144615472915715e-08 -0.09988258867052513 -2.4487 0.7068998799352189 0.7068986358258169 5.548150660596163e-08 -0.09988262431696904 -2.4488000000000003 0.7068999440117925 0.7068986977771934 5.5795562968474766e-08 -0.09988265995259693 -2.4489 0.7069000080723289 0.7068987597063555 5.608671905382723e-08 -0.09988269557741203 -2.449 0.7069000721165876 0.7068988216135561 5.6354914641093545e-08 -0.09988273119141773 -2.4491 0.7069001361443266 0.7068988834990482 5.660009482974515e-08 -0.09988276679461723 -2.4492000000000003 0.7069002001553043 0.7068989453630852 5.682221004658927e-08 -0.09988280238701383 -2.4493 0.7069002641492781 0.7068990072059214 5.702121604056476e-08 -0.0998828379686108 -2.4494000000000002 0.7069003281260049 0.7068990690278107 5.719707391223239e-08 -0.09988287353941135 -2.4495 0.7069003920852416 0.7068991308290086 5.734975011550958e-08 -0.09988290909941883 -2.4495999999999998 0.7069004560267447 0.7068991926097702 5.747921645593568e-08 -0.0998829446486365 -2.4497000000000004 0.7069005199502703 0.7068992543703505 5.758545009934557e-08 -0.09988298018706762 -2.4498 0.7069005838555746 0.7068993161110052 5.7668433584012746e-08 -0.09988301571471547 -2.4499 0.7069006477424137 0.7068993778319896 5.7728154806771514e-08 -0.09988305123158327 -2.45 0.7069007116105432 0.7068994395335599 5.776460703862951e-08 -0.09988308673767433 -2.4501 0.706900775459719 0.7068995012159716 5.777778891435936e-08 -0.09988312223299195 -2.4502 0.7069008392896969 0.7068995628794803 5.776770443943757e-08 -0.0998831577175393 -2.4503000000000004 0.7069009031002332 0.7068996245243415 5.773436298137091e-08 -0.09988319319131975 -2.4504 0.7069009668910838 0.7068996861508109 5.767777927663531e-08 -0.09988322865433649 -2.4505 0.7069010306620052 0.7068997477591432 5.759797340812445e-08 -0.09988326410659279 -2.4506 0.7069010944127541 0.7068998093495936 5.7494970813823376e-08 -0.09988329954809194 -2.4507000000000003 0.7069011581430875 0.7068998709224166 5.736880226946128e-08 -0.09988333497883721 -2.4508 0.7069012218527629 0.7068999324778662 5.721950388330732e-08 -0.09988337039883183 -2.4509000000000003 0.7069012855415379 0.706899994016196 5.7047117094435884e-08 -0.099883405808079 -2.451 0.7069013492091711 0.7069000555376592 5.685168864844048e-08 -0.0998834412065821 -2.4511 0.7069014128554214 0.7069001170425084 5.663327059396428e-08 -0.09988347659434428 -2.4512000000000005 0.7069014764800483 0.7069001785309956 5.639192026361817e-08 -0.09988351197136885 -2.4513000000000003 0.7069015400828121 0.7069002400033721 5.612770026357239e-08 -0.09988354733765906 -2.4514 0.7069016036634739 0.7069003014598886 5.5840678451005155e-08 -0.09988358269321818 -2.4515 0.7069016672217951 0.7069003629007946 5.5530927923694295e-08 -0.09988361803804943 -2.4516 0.7069017307575388 0.7069004243263389 5.519852700440475e-08 -0.09988365337215609 -2.4517 0.7069017942704683 0.7069004857367698 5.484355920966355e-08 -0.09988368869554139 -2.4518 0.706901857760348 0.7069005471323342 5.4466113234147295e-08 -0.09988372400820858 -2.4519 0.7069019212269433 0.7069006085132779 5.4066282940273824e-08 -0.09988375931016089 -2.452 0.7069019846700209 0.7069006698798459 5.364416730789523e-08 -0.09988379460140157 -2.4520999999999997 0.7069020480893486 0.7069007312322823 5.319987044123675e-08 -0.09988382988193392 -2.4522000000000004 0.7069021114846954 0.7069007925708292 5.2733501522059245e-08 -0.09988386515176112 -2.4523 0.7069021748558308 0.7069008538957283 5.2245174788842497e-08 -0.09988390041088642 -2.4524 0.7069022382025267 0.70690091520722 5.17350095124991e-08 -0.09988393565931314 -2.4525 0.7069023015245559 0.7069009765055427 5.120312996167997e-08 -0.09988397089704451 -2.4526 0.7069023648216921 0.7069010377909337 5.06496653819577e-08 -0.09988400612408366 -2.4527 0.7069024280937114 0.7069010990636289 5.007474995419314e-08 -0.09988404134043395 -2.4528000000000003 0.7069024913403905 0.7069011603238626 4.947852275810627e-08 -0.09988407654609854 -2.4529 0.706902554561508 0.706901221571868 4.88611277549289e-08 -0.0998841117410807 -2.453 0.7069026177568443 0.706901282807876 4.822271373883247e-08 -0.09988414692538364 -2.4531 0.7069026809261811 0.7069013440321162 4.7563434319580766e-08 -0.09988418209901065 -2.4532000000000003 0.7069027440693023 0.7069014052448167 4.688344785661047e-08 -0.09988421726196496 -2.4533 0.7069028071859932 0.7069014664462032 4.618291744515335e-08 -0.09988425241424977 -2.4534000000000002 0.7069028702760407 0.7069015276365005 4.546201086939872e-08 -0.09988428755586831 -2.4535 0.706902933339234 0.7069015888159307 4.472090055739064e-08 -0.09988432268682387 -2.4536 0.7069029963753641 0.7069016499847143 4.395976354459874e-08 -0.09988435780711963 -2.4537000000000004 0.7069030593842237 0.7069017111430698 4.317878143748899e-08 -0.09988439291675882 -2.4538 0.7069031223656079 0.7069017722912139 4.2378140368420913e-08 -0.09988442801574471 -2.4539 0.7069031853193135 0.7069018334293611 4.1558030929728096e-08 -0.0998844631040805 -2.454 0.7069032482451394 0.7069018945577237 4.071864815984039e-08 -0.09988449818176938 -2.4541 0.7069033111428873 0.7069019556765118 3.986019147909914e-08 -0.09988453324881466 -2.4542 0.70690337401236 0.7069020167859337 3.898286464812384e-08 -0.09988456830521952 -2.4543000000000004 0.7069034368533635 0.706902077886195 3.808687571750513e-08 -0.09988460335098719 -2.4544 0.7069034996657055 0.7069021389774992 3.717243697923256e-08 -0.09988463838612086 -2.4545 0.7069035624491964 0.7069022000600476 3.623976491812231e-08 -0.0998846734106238 -2.4546 0.7069036252036487 0.706902261134039 3.528908015630605e-08 -0.09988470842449923 -2.4547000000000003 0.7069036879288773 0.7069023221996695 3.432060739945453e-08 -0.09988474342775033 -2.4548 0.7069037506247 0.7069023832571334 3.333457539340945e-08 -0.09988477842038036 -2.4549000000000003 0.7069038132909367 0.7069024443066217 3.233121685826401e-08 -0.09988481340239252 -2.455 0.7069038759274098 0.7069025053483238 3.131076844152536e-08 -0.09988484837379007 -2.4551 0.7069039385339444 0.7069025663824255 3.027347067127706e-08 -0.09988488333457617 -2.4552000000000005 0.7069040011103684 0.7069026274091106 2.921956787464708e-08 -0.09988491828475404 -2.4553000000000003 0.7069040636565125 0.70690268842856 2.814930814311334e-08 -0.09988495322432697 -2.4554 0.7069041261722093 0.7069027494409517 2.7062943261380035e-08 -0.09988498815329806 -2.4555 0.7069041886572951 0.7069028104464613 2.5960728653601217e-08 -0.09988502307167059 -2.4556 0.7069042511116085 0.7069028714452616 2.4842923326134914e-08 -0.09988505797944779 -2.4557 0.7069043135349908 0.7069029324375227 2.370978979295002e-08 -0.09988509287663283 -2.4558 0.7069043759272866 0.7069029934234115 2.256159403052349e-08 -0.09988512776322894 -2.4559 0.706904438288343 0.7069030544030916 2.139860540931876e-08 -0.09988516263923931 -2.456 0.7069045006180104 0.7069031153767249 2.0221096623529444e-08 -0.09988519750466723 -2.4560999999999997 0.7069045629161416 0.7069031763444691 1.9029343639904994e-08 -0.0998852323595158 -2.4562000000000004 0.7069046251825928 0.7069032373064794 1.78236256274944e-08 -0.09988526720378822 -2.4563 0.7069046874172235 0.7069032982629082 1.6604224883053076e-08 -0.09988530203748779 -2.4564 0.7069047496198955 0.7069033592139047 1.5371426784205333e-08 -0.09988533686061762 -2.4565 0.7069048117904746 0.7069034201596142 1.4125519709647094e-08 -0.09988537167318096 -2.4566 0.7069048739288292 0.7069034811001802 1.2866794962818062e-08 -0.09988540647518102 -2.4567 0.706904936034831 0.7069035420357422 1.1595546732003081e-08 -0.09988544126662104 -2.4568000000000003 0.7069049981083544 0.7069036029664367 1.0312071996657068e-08 -0.09988547604750414 -2.4569 0.706905060149278 0.7069036638923967 9.01667046582233e-09 -0.09988551081783353 -2.457 0.7069051221574829 0.7069037248137526 7.709644503535451e-09 -0.09988554557761244 -2.4571 0.7069051841328537 0.706903785730631 6.3912990776529566e-09 -0.09988558032684408 -2.4572000000000003 0.7069052460752785 0.7069038466431552 5.061941663574154e-09 -0.09988561506553165 -2.4573 0.7069053079846482 0.7069039075514453 3.7218821826584536e-09 -0.0998856497936783 -2.4574000000000003 0.7069053698608578 0.706903968455618 2.3714329311017024e-09 -0.09988568451128725 -2.4575 0.7069054317038048 0.7069040293557868 1.0109085131493334e-09 -0.09988571921836169 -2.4576000000000002 0.7069054935133909 0.7069040902520614 -3.593742395682775e-10 -0.09988575391490483 -2.4577000000000004 0.7069055552895207 0.7069041511445485 -1.7390963513025381e-09 -0.09988578860091982 -2.4578 0.7069056170321026 0.706904212033351 -3.1279367507588973e-09 -0.0998858232764099 -2.4579 0.7069056787410484 0.7069042729185683 -4.525572372578168e-09 -0.0998858579413782 -2.458 0.7069057404162732 0.7069043338002968 -5.93167821805185e-09 -0.09988589259582797 -2.4581000000000004 0.7069058020576959 0.7069043946786291 -7.3459274271131525e-09 -0.09988592723976242 -2.4582 0.7069058636652383 0.7069044555536538 -8.767991366807892e-09 -0.09988596187318464 -2.4583000000000004 0.7069059252388268 0.7069045164254564 -1.0197539700683433e-08 -0.09988599649609786 -2.4584 0.7069059867783904 0.7069045772941194 -1.1634240463815476e-08 -0.0998860311085053 -2.4585 0.706906048283862 0.7069046381597206 -1.3077760143039019e-08 -0.09988606571041012 -2.4586000000000006 0.7069061097551783 0.7069046990223349 -1.4527763755444595e-08 -0.09988610030181545 -2.4587000000000003 0.7069061711922796 0.706904759882033 -1.5983914920802977e-08 -0.09988613488272455 -2.4588 0.7069062325951097 0.706904820738883 -1.744587594700031e-08 -0.0998861694531406 -2.4589000000000003 0.7069062939636157 0.7069048815929483 -1.891330789899337e-08 -0.09988620401306673 -2.459 0.706906355297749 0.7069049424442891 -2.0385870685545732e-08 -0.09988623856250617 -2.4591000000000003 0.7069064165974642 0.706905003292962 -2.186322313598929e-08 -0.09988627310146202 -2.4592 0.7069064778627199 0.7069050641390198 -2.334502307611841e-08 -0.09988630762993753 -2.4593000000000003 0.706906539093478 0.7069051249825116 -2.483092741145665e-08 -0.09988634214793585 -2.4594 0.7069066002897042 0.7069051858234827 -2.6320592201849874e-08 -0.09988637665546013 -2.4595 0.7069066614513685 0.706905246661975 -2.7813672747768747e-08 -0.09988641115251362 -2.4596000000000005 0.7069067225784438 0.7069053074980266 -2.9309823662950277e-08 -0.09988644563909943 -2.4597 0.7069067836709071 0.7069053683316715 -3.080869895831506e-08 -0.09988648011522076 -2.4598 0.706906844728739 0.7069054291629406 -3.23099521234993e-08 -0.09988651458088077 -2.4599 0.7069069057519239 0.7069054899918608 -3.3813236202315244e-08 -0.09988654903608266 -2.46 0.7069069667404501 0.7069055508184546 -3.531820387493376e-08 -0.09988658348082956 -2.4601 0.7069070276943092 0.7069056116427419 -3.682450753887418e-08 -0.09988661791512465 -2.4602000000000004 0.7069070886134966 0.7069056724647382 -3.83317993907532e-08 -0.0998866523389711 -2.4603 0.7069071494980121 0.7069057332844555 -3.9839731500715316e-08 -0.09988668675237208 -2.4604 0.7069072103478586 0.7069057941019017 -4.134795589911481e-08 -0.09988672115533076 -2.4605 0.7069072711630426 0.7069058549170812 -4.2856124654144616e-08 -0.09988675554785026 -2.4606000000000003 0.706907331943575 0.7069059157299953 -4.436388995143032e-08 -0.09988678992993384 -2.4607 0.7069073926894698 0.7069059765406404 -4.587090417503361e-08 -0.09988682430158462 -2.4608000000000003 0.7069074534007449 0.7069060373490095 -4.737681998741219e-08 -0.09988685866280567 -2.4609 0.7069075140774222 0.7069060981550926 -4.8881290409244146e-08 -0.09988689301360028 -2.461 0.706907574719527 0.7069061589588753 -5.038396889978092e-08 -0.09988692735397153 -2.4611000000000005 0.7069076353270886 0.7069062197603397 -5.1884509436658094e-08 -0.09988696168392264 -2.4612000000000003 0.7069076959001397 0.7069062805594638 -5.3382566595665606e-08 -0.09988699600345669 -2.4613 0.706907756438717 0.7069063413562228 -5.48777956289187e-08 -0.09988703031257695 -2.4614000000000003 0.7069078169428604 0.7069064021505871 -5.6369852545739424e-08 -0.09988706461128648 -2.4615 0.7069078774126142 0.7069064629425243 -5.785839419202021e-08 -0.09988709889958847 -2.4616000000000002 0.7069079378480256 0.7069065237319978 -5.934307832698542e-08 -0.09988713317748604 -2.4617000000000004 0.7069079982491463 0.7069065845189677 -6.082356370168754e-08 -0.09988716744498242 -2.4618 0.7069080586160309 0.7069066453033899 -6.229951014140658e-08 -0.0998872017020807 -2.4619 0.7069081189487377 0.7069067060852173 -6.377057862111055e-08 -0.09988723594878399 -2.462 0.7069081792473296 0.7069067668643989 -6.523643134026536e-08 -0.09988727018509558 -2.4621000000000004 0.7069082395118718 0.7069068276408799 -6.669673180805316e-08 -0.0998873044110185 -2.4622 0.7069082997424335 0.7069068884146024 -6.815114491492968e-08 -0.09988733862655591 -2.4623000000000004 0.7069083599390882 0.7069069491855043 -6.9599337007651e-08 -0.09988737283171102 -2.4624 0.706908420101912 0.7069070099535206 -7.104097596907083e-08 -0.09988740702648696 -2.4625 0.7069084802309852 0.7069070707185818 -7.247573129663676e-08 -0.09988744121088683 -2.4626000000000006 0.7069085403263912 0.7069071314806157 -7.390327417524864e-08 -0.09988747538491377 -2.4627000000000003 0.7069086003882172 0.7069071922395467 -7.532327754968329e-08 -0.09988750954857102 -2.4628 0.7069086604165538 0.7069072529952949 -7.673541620525914e-08 -0.09988754370186165 -2.4629000000000003 0.706908720411495 0.7069073137477774 -7.813936683982725e-08 -0.09988757784478879 -2.463 0.7069087803731382 0.706907374496908 -7.953480813532865e-08 -0.09988761197735559 -2.4631000000000003 0.7069088403015844 0.706907435242597 -8.09214208358569e-08 -0.09988764609956524 -2.4632 0.706908900196938 0.7069074959847509 -8.229888781748074e-08 -0.09988768021142085 -2.4633000000000003 0.7069089600593066 0.7069075567232733 -8.366689415763295e-08 -0.09988771431292554 -2.4634 0.7069090198888013 0.7069076174580642 -8.502512721837718e-08 -0.09988774840408243 -2.4635 0.7069090796855364 0.7069076781890203 -8.637327670365375e-08 -0.09988778248489472 -2.4636000000000005 0.7069091394496294 0.7069077389160352 -8.771103474254638e-08 -0.09988781655536548 -2.4637000000000002 0.7069091991812015 0.7069077996389989 -8.903809595346701e-08 -0.09988785061549786 -2.4638 0.7069092588803769 0.7069078603577982 -9.035415750573844e-08 -0.09988788466529502 -2.4639 0.706909318547283 0.7069079210723168 -9.165891920719788e-08 -0.09988791870476009 -2.464 0.7069093781820504 0.7069079817824355 -9.295208356057544e-08 -0.09988795273389622 -2.4641 0.7069094377848126 0.7069080424880315 -9.423335582941367e-08 -0.0998879867527065 -2.4642000000000004 0.706909497355707 0.7069081031889788 -9.55024441109259e-08 -0.09988802076119406 -2.4643 0.7069095568948729 0.7069081638851485 -9.67590594010484e-08 -0.09988805475936204 -2.4644 0.7069096164024539 0.7069082245764087 -9.800291566122721e-08 -0.09988808874721355 -2.4645 0.7069096758785958 0.7069082852626245 -9.923372988000084e-08 -0.09988812272475177 -2.4646000000000003 0.7069097353234479 0.7069083459436578 -1.004512221449913e-07 -0.09988815669197981 -2.4647 0.7069097947371622 0.7069084066193676 -1.0165511569321106e-07 -0.09988819064890075 -2.4648000000000003 0.7069098541198935 0.7069084672896098 -1.028451369873909e-07 -0.09988822459551772 -2.4649 0.7069099134717999 0.7069085279542378 -1.040210157654195e-07 -0.09988825853183389 -2.465 0.7069099727930419 0.7069085886131019 -1.0518248512014078e-07 -0.09988829245785236 -2.4651000000000005 0.7069100320837832 0.7069086492660497 -1.0632928153925247e-07 -0.09988832637357627 -2.4652000000000003 0.7069100913441901 0.7069087099129255 -1.0746114497556247e-07 -0.09988836027900867 -2.4653 0.7069101505744317 0.7069087705535717 -1.0857781890249996e-07 -0.09988839417415277 -2.4654000000000003 0.70691020977468 0.7069088311878272 -1.0967905038176962e-07 -0.0998884280590116 -2.4655 0.7069102689451092 0.7069088918155285 -1.10764590114526e-07 -0.09988846193358836 -2.4656000000000002 0.7069103280858965 0.70690895243651 -1.1183419248821103e-07 -0.09988849579788611 -2.4657000000000004 0.7069103871972217 0.7069090130506028 -1.1288761564247352e-07 -0.09988852965190803 -2.4658 0.7069104462792666 0.7069090736576358 -1.1392462152121086e-07 -0.09988856349565718 -2.4659 0.7069105053322164 0.706909134257435 -1.1494497592634545e-07 -0.09988859732913664 -2.466 0.7069105643562581 0.7069091948498244 -1.1594844857507058e-07 -0.09988863115234961 -2.4661000000000004 0.7069106233515814 0.7069092554346255 -1.1693481314668797e-07 -0.09988866496529919 -2.4662 0.7069106823183784 0.7069093160116566 -1.179038473329147e-07 -0.09988869876798837 -2.4663000000000004 0.7069107412568433 0.7069093765807353 -1.1885533288645556e-07 -0.09988873256042041 -2.4664 0.7069108001671728 0.7069094371416755 -1.197890556765141e-07 -0.09988876634259834 -2.4665 0.7069108590495656 0.7069094976942891 -1.2070480574083442e-07 -0.09988880011452526 -2.4666000000000006 0.7069109179042232 0.7069095582383865 -1.2160237731866086e-07 -0.09988883387620434 -2.4667000000000003 0.7069109767313486 0.7069096187737752 -1.2248156889757555e-07 -0.09988886762763866 -2.4668 0.7069110355311472 0.7069096793002609 -1.2334218328635682e-07 -0.0998889013688313 -2.4669 0.7069110943038261 0.7069097398176472 -1.2418402761324443e-07 -0.09988893509978536 -2.467 0.7069111530495951 0.7069098003257356 -1.2500691340400216e-07 -0.09988896882050396 -2.4671000000000003 0.7069112117686656 0.7069098608243258 -1.2581065662181645e-07 -0.09988900253099027 -2.4672 0.7069112704612506 0.7069099213132154 -1.2659507769505196e-07 -0.0998890362312473 -2.4673000000000003 0.7069113291275654 0.7069099817921999 -1.2736000155368077e-07 -0.0998890699212781 -2.4674 0.7069113877678275 0.7069100422610735 -1.2810525768479353e-07 -0.09988910360108594 -2.4675 0.706911446382255 0.7069101027196284 -1.2883068016902866e-07 -0.09988913727067379 -2.4676000000000005 0.7069115049710686 0.7069101631676551 -1.2953610769791957e-07 -0.09988917093004476 -2.4677000000000002 0.7069115635344905 0.7069102236049425 -1.302213836484878e-07 -0.099889204579202 -2.4678 0.7069116220727447 0.7069102840312775 -1.3088635606069154e-07 -0.09988923821814857 -2.4679 0.7069116805860566 0.7069103444464457 -1.3153087771895777e-07 -0.0998892718468876 -2.468 0.7069117390746527 0.7069104048502313 -1.321548061729988e-07 -0.09988930546542213 -2.4681 0.7069117975387615 0.7069104652424167 -1.3275800375689428e-07 -0.09988933907375526 -2.4682000000000004 0.706911855978613 0.7069105256227834 -1.3334033763072461e-07 -0.09988937267189012 -2.4683 0.7069119143944381 0.7069105859911111 -1.3390167981006118e-07 -0.09988940625982978 -2.4684 0.7069119727864694 0.7069106463471779 -1.3444190718851778e-07 -0.09988943983757732 -2.4685 0.7069120311549407 0.7069107066907614 -1.3496090156030205e-07 -0.09988947340513588 -2.4686000000000003 0.7069120895000867 0.7069107670216376 -1.3545854965837933e-07 -0.09988950696250848 -2.4687 0.7069121478221434 0.7069108273395812 -1.3593474317181997e-07 -0.09988954050969827 -2.4688000000000003 0.7069122061213482 0.7069108876443659 -1.3638937878222845e-07 -0.09988957404670826 -2.4689 0.7069122643979393 0.7069109479357647 -1.3682235815853927e-07 -0.0998896075735416 -2.469 0.7069123226521558 0.7069110082135491 -1.3723358799171137e-07 -0.09988964109020135 -2.4691000000000005 0.7069123808842377 0.70691106847749 -1.376229800346268e-07 -0.09988967459669057 -2.4692000000000003 0.7069124390944264 0.7069111287273571 -1.3799045109341712e-07 -0.09988970809301241 -2.4693 0.7069124972829637 0.7069111889629195 -1.383359230552189e-07 -0.09988974157916991 -2.4694000000000003 0.7069125554500919 0.7069112491839453 -1.3865932289684746e-07 -0.09988977505516614 -2.4695 0.7069126135960546 0.7069113093902023 -1.3896058272643008e-07 -0.09988980852100414 -2.4696000000000002 0.7069126717210958 0.7069113695814575 -1.392396397573853e-07 -0.0998898419766871 -2.4697000000000005 0.7069127298254605 0.7069114297574769 -1.3949643636219922e-07 -0.09988987542221807 -2.4698 0.7069127879093933 0.7069114899180262 -1.3973092005507837e-07 -0.09988990885760007 -2.4699 0.7069128459731401 0.7069115500628709 -1.399430435179705e-07 -0.09988994228283621 -2.47 0.7069129040169471 0.7069116101917754 -1.4013276459362567e-07 -0.09988997569792954 -2.4701000000000004 0.7069129620410604 0.7069116703045042 -1.4030004630814774e-07 -0.09989000910288316 -2.4702 0.7069130200457274 0.7069117304008214 -1.4044485688313735e-07 -0.09989004249770013 -2.4703000000000004 0.7069130780311949 0.7069117904804909 -1.405671697252836e-07 -0.09989007588238356 -2.4704 0.7069131359977103 0.7069118505432759 -1.4066696343677243e-07 -0.09989010925693648 -2.4705 0.7069131939455211 0.7069119105889399 -1.407442218256949e-07 -0.09989014262136194 -2.4706000000000006 0.7069132518748747 0.7069119706172463 -1.4079893389910836e-07 -0.09989017597566303 -2.4707000000000003 0.7069133097860192 0.7069120306279582 -1.408310938578322e-07 -0.09989020931984287 -2.4708 0.7069133676792021 0.7069120906208388 -1.4084070112593827e-07 -0.09989024265390449 -2.4709 0.706913425554671 0.7069121505956514 -1.4082776030564792e-07 -0.09989027597785095 -2.471 0.7069134834126729 0.7069122105521592 -1.407922812276391e-07 -0.0998903092916853 -2.4711000000000003 0.7069135412534557 0.7069122704901261 -1.407342788938004e-07 -0.09989034259541064 -2.4712 0.7069135990772665 0.7069123304093156 -1.4065377350325203e-07 -0.09989037588903005 -2.4713000000000003 0.7069136568843516 0.7069123903094916 -1.405507904349984e-07 -0.09989040917254653 -2.4714 0.7069137146749577 0.7069124501904189 -1.404253602566019e-07 -0.09989044244596318 -2.4715 0.7069137724493308 0.7069125100518622 -1.4027751868428417e-07 -0.09989047570928306 -2.4716000000000005 0.7069138302077167 0.7069125698935863 -1.4010730661415116e-07 -0.09989050896250923 -2.4717000000000002 0.7069138879503605 0.7069126297153574 -1.3991477007882502e-07 -0.09989054220564476 -2.4718 0.7069139456775066 0.7069126895169418 -1.396999602370358e-07 -0.0998905754386927 -2.4719 0.706914003389399 0.7069127492981058 -1.3946293338056026e-07 -0.09989060866165611 -2.472 0.7069140610862807 0.7069128090586176 -1.3920375090646642e-07 -0.09989064187453801 -2.4721 0.7069141187683948 0.706912868798245 -1.3892247931017454e-07 -0.0998906750773415 -2.4722000000000004 0.7069141764359826 0.7069129285167574 -1.3861919014382384e-07 -0.09989070827006963 -2.4723 0.7069142340892851 0.7069129882139245 -1.3829396002668082e-07 -0.09989074145272545 -2.4724 0.7069142917285426 0.7069130478895169 -1.3794687062432254e-07 -0.09989077462531198 -2.4725 0.706914349353994 0.7069131075433066 -1.3757800860006442e-07 -0.09989080778783235 -2.4726000000000004 0.7069144069658775 0.7069131671750664 -1.3718746562016437e-07 -0.09989084094028952 -2.4727 0.7069144645644296 0.7069132267845697 -1.3677533833127142e-07 -0.0998908740826866 -2.4728000000000003 0.7069145221498869 0.7069132863715916 -1.3634172831879232e-07 -0.0998909072150266 -2.4729 0.7069145797224843 0.7069133459359078 -1.3588674209301377e-07 -0.0998909403373126 -2.473 0.7069146372824551 0.7069134054772956 -1.3541049106828573e-07 -0.09989097344954767 -2.4731000000000005 0.7069146948300316 0.7069134649955336 -1.3491309152659225e-07 -0.09989100655173479 -2.4732000000000003 0.7069147523654449 0.7069135244904015 -1.3439466459326532e-07 -0.09989103964387706 -2.4733 0.7069148098889244 0.7069135839616802 -1.3385533620749457e-07 -0.09989107272597747 -2.4734000000000003 0.7069148674006989 0.7069136434091525 -1.3329523708242863e-07 -0.09989110579803911 -2.4735 0.7069149249009947 0.706913702832602 -1.3271450268956264e-07 -0.09989113886006501 -2.4736000000000002 0.7069149823900375 0.7069137622318146 -1.3211327322577848e-07 -0.09989117191205821 -2.4737000000000005 0.7069150398680507 0.7069138216065771 -1.3149169355262946e-07 -0.09989120495402176 -2.4738 0.7069150973352565 0.7069138809566786 -1.308499132032792e-07 -0.09989123798595873 -2.4739 0.7069151547918753 0.706913940281909 -1.301880863096433e-07 -0.0998912710078721 -2.474 0.7069152122381257 0.7069139995820604 -1.2950637159198086e-07 -0.09989130401976495 -2.4741000000000004 0.7069152696742249 0.7069140588569267 -1.288049323016488e-07 -0.09989133702164028 -2.4742 0.7069153271003876 0.7069141181063036 -1.2808393618640723e-07 -0.09989137001350115 -2.4743000000000004 0.7069153845168277 0.7069141773299882 -1.2734355546439868e-07 -0.09989140299535058 -2.4744 0.706915441923756 0.7069142365277803 -1.2658396675822858e-07 -0.09989143596719165 -2.4745 0.7069154993213822 0.7069142956994809 -1.258053510758833e-07 -0.09989146892902734 -2.4746000000000006 0.7069155567099137 0.7069143548448935 -1.2500789376215793e-07 -0.09989150188086071 -2.4747000000000003 0.7069156140895558 0.7069144139638234 -1.2419178445008394e-07 -0.09989153482269476 -2.4748 0.706915671460512 0.7069144730560779 -1.233572170106223e-07 -0.09989156775453259 -2.4749 0.7069157288229835 0.7069145321214668 -1.2250438951623421e-07 -0.09989160067637719 -2.475 0.7069157861771688 0.7069145911598017 -1.2163350419577834e-07 -0.09989163358823154 -2.4751000000000003 0.7069158435232649 0.7069146501708965 -1.2074476737899964e-07 -0.09989166649009873 -2.4752 0.7069159008614663 0.7069147091545678 -1.1983838944622238e-07 -0.09989169938198177 -2.4753000000000003 0.7069159581919651 0.7069147681106339 -1.1891458478498207e-07 -0.09989173226388372 -2.4754 0.7069160155149512 0.7069148270389157 -1.1797357173971845e-07 -0.09989176513580754 -2.4755 0.7069160728306118 0.7069148859392365 -1.1701557255279493e-07 -0.09989179799775627 -2.4756000000000005 0.7069161301391322 0.706914944811422 -1.1604081331939575e-07 -0.099891830849733 -2.4757000000000002 0.7069161874406948 0.7069150036553002 -1.1504952394242318e-07 -0.09989186369174068 -2.4758 0.7069162447354794 0.7069150624707021 -1.140419380492308e-07 -0.0998918965237823 -2.4759 0.7069163020236638 0.7069151212574611 -1.130182929638679e-07 -0.09989192934586104 -2.476 0.7069163593054226 0.706915180015413 -1.1197882964289474e-07 -0.0998919621579798 -2.4761 0.7069164165809281 0.7069152387443958 -1.1092379262507557e-07 -0.09989199496014159 -2.4762000000000004 0.7069164738503495 0.706915297444251 -1.0985342994984659e-07 -0.09989202775234945 -2.4763 0.706916531113854 0.7069153561148227 -1.087679931278257e-07 -0.09989206053460645 -2.4764 0.7069165883716053 0.7069154147559572 -1.0766773706708671e-07 -0.09989209330691552 -2.4765 0.706916645623765 0.7069154733675039 -1.0655292002198502e-07 -0.09989212606927973 -2.4766000000000004 0.7069167028704915 0.706915531949315 -1.0542380351943187e-07 -0.09989215882170205 -2.4767 0.7069167601119404 0.7069155905012456 -1.0428065230945471e-07 -0.09989219156418554 -2.4768000000000003 0.7069168173482645 0.7069156490231536 -1.031237342932062e-07 -0.0998922242967332 -2.4769 0.7069168745796135 0.7069157075149 -1.0195332048133082e-07 -0.09989225701934806 -2.477 0.7069169318061344 0.7069157659763482 -1.0076968489508564e-07 -0.0998922897320331 -2.4771000000000005 0.706916989027971 0.706915824407365 -9.957310453424795e-08 -0.09989232243479126 -2.4772000000000003 0.7069170462452641 0.7069158828078206 -9.836385929471586e-08 -0.09989235512762569 -2.4773 0.7069171034581516 0.7069159411775876 -9.714223191386456e-08 -0.09989238781053932 -2.4774000000000003 0.7069171606667685 0.7069159995165417 -9.59085078976879e-08 -0.09989242048353515 -2.4775 0.7069172178712463 0.7069160578245621 -9.466297545227681e-08 -0.09989245314661627 -2.4776000000000002 0.7069172750717133 0.7069161161015308 -9.340592542223664e-08 -0.09989248579978555 -2.4777000000000005 0.7069173322682952 0.7069161743473331 -9.213765122476764e-08 -0.09989251844304611 -2.4778000000000002 0.706917389461114 0.7069162325618573 -9.08584487698677e-08 -0.09989255107640091 -2.4779 0.7069174466502892 0.7069162907449953 -8.956861639874969e-08 -0.09989258369985297 -2.478 0.7069175038359357 0.7069163488966417 -8.826845482312606e-08 -0.09989261631340524 -2.4781000000000004 0.7069175610181664 0.7069164070166948 -8.695826703673804e-08 -0.09989264891706075 -2.4782 0.7069176181970904 0.7069164651050559 -8.563835825550759e-08 -0.09989268151082253 -2.4783000000000004 0.706917675372814 0.70691652316163 -8.430903585075061e-08 -0.09989271409469357 -2.4784 0.7069177325454393 0.7069165811863249 -8.297060926591021e-08 -0.09989274666867684 -2.4785 0.7069177897150657 0.7069166391790519 -8.162338995063717e-08 -0.09989277923277534 -2.4786000000000006 0.7069178468817892 0.7069166971397259 -8.026769128879896e-08 -0.09989281178699211 -2.4787000000000003 0.7069179040457021 0.7069167550682651 -7.890382852909078e-08 -0.09989284433133011 -2.4788 0.7069179612068932 0.706916812964591 -7.753211870697302e-08 -0.09989287686579229 -2.4789 0.7069180183654482 0.7069168708286285 -7.615288056574132e-08 -0.09989290939038169 -2.479 0.7069180755214496 0.7069169286603062 -7.476643449190815e-08 -0.09989294190510133 -2.4791000000000003 0.706918132674976 0.7069169864595557 -7.337310243757389e-08 -0.09989297440995419 -2.4792 0.7069181898261025 0.7069170442263126 -7.197320784886954e-08 -0.09989300690494322 -2.4793000000000003 0.7069182469749011 0.7069171019605156 -7.056707558442468e-08 -0.09989303939007146 -2.4794 0.7069183041214397 0.7069171596621071 -6.915503184207542e-08 -0.09989307186534185 -2.4795 0.7069183612657832 0.706917217331033 -6.77374040855723e-08 -0.09989310433075742 -2.4796000000000005 0.7069184184079926 0.7069172749672425 -6.631452096825252e-08 -0.09989313678632111 -2.4797000000000002 0.7069184755481257 0.7069173325706889 -6.488671225454365e-08 -0.09989316923203598 -2.4798 0.7069185326862367 0.7069173901413287 -6.345430874537053e-08 -0.099893201667905 -2.4799 0.7069185898223758 0.7069174476791216 -6.201764220442954e-08 -0.09989323409393111 -2.48 0.7069186469565903 0.7069175051840311 -6.057704527318714e-08 -0.09989326651011729 -2.4801 0.7069187040889233 0.7069175626560251 -5.9132851403225634e-08 -0.0998932989164666 -2.4802000000000004 0.7069187612194145 0.7069176200950738 -5.7685394771024925e-08 -0.09989333131298193 -2.4803 0.7069188183481002 0.7069176775011516 -5.623501020705565e-08 -0.09989336369966628 -2.4804 0.706918875475013 0.7069177348742367 -5.478203311619877e-08 -0.09989339607652267 -2.4805 0.7069189326001817 0.7069177922143107 -5.332679939643037e-08 -0.09989342844355405 -2.4806000000000004 0.7069189897236317 0.7069178495213588 -5.186964536704752e-08 -0.09989346080076343 -2.4807 0.7069190468453848 0.7069179067953696 -5.041090768854572e-08 -0.09989349314815371 -2.4808000000000003 0.7069191039654588 0.7069179640363358 -4.895092328477315e-08 -0.09989352548572794 -2.4809 0.7069191610838683 0.7069180212442536 -4.749002926356712e-08 -0.0998935578134891 -2.481 0.7069192182006244 0.7069180784191222 -4.602856284156463e-08 -0.09989359013144013 -2.4811000000000005 0.706919275315734 0.7069181355609455 -4.456686126592295e-08 -0.099893622439584 -2.4812000000000003 0.7069193324292009 0.7069181926697299 -4.3105261734603705e-08 -0.09989365473792372 -2.4813 0.7069193895410251 0.7069182497454863 -4.16441013208988e-08 -0.09989368702646224 -2.4814000000000003 0.7069194466512028 0.7069183067882288 -4.0183716894324345e-08 -0.09989371930520256 -2.4815 0.7069195037597267 0.7069183637979748 -3.872444504491625e-08 -0.09989375157414754 -2.4816000000000003 0.7069195608665861 0.7069184207747458 -3.7266622001535556e-08 -0.09989378383330023 -2.4817000000000005 0.7069196179717667 0.7069184777185672 -3.58105835588339e-08 -0.09989381608266368 -2.4818000000000002 0.70691967507525 0.7069185346294671 -3.4356664998743715e-08 -0.09989384832224073 -2.4819 0.7069197321770142 0.706918591507478 -3.290520101143987e-08 -0.09989388055203435 -2.482 0.7069197892770347 0.7069186483526356 -3.14565256202045e-08 -0.09989391277204758 -2.4821000000000004 0.7069198463752822 0.7069187051649792 -3.0010972104557027e-08 -0.09989394498228338 -2.4822 0.7069199034717242 0.7069187619445517 -2.8568872921649544e-08 -0.09989397718274463 -2.4823000000000004 0.706919960566325 0.7069188186913995 -2.7130559631782097e-08 -0.09989400937343437 -2.4824 0.7069200176590451 0.7069188754055729 -2.569636282315907e-08 -0.09989404155435558 -2.4825 0.7069200747498413 0.706918932087125 -2.426661203187505e-08 -0.09989407372551116 -2.4826000000000006 0.7069201318386669 0.7069189887361131 -2.284163567317643e-08 -0.09989410588690407 -2.4827000000000004 0.706920188925472 0.7069190453525976 -2.142176095711046e-08 -0.0998941380385373 -2.4828 0.7069202460102029 0.706919101936643 -2.0007313820437356e-08 -0.09989417018041381 -2.4829 0.7069203030928026 0.7069191584883165 -1.8598618848567755e-08 -0.0998942023125366 -2.483 0.7069203601732102 0.7069192150076893 -1.7195999202270634e-08 -0.09989423443490847 -2.4831000000000003 0.7069204172513621 0.7069192714948356 -1.5799776542646526e-08 -0.0998942665475325 -2.4832 0.7069204743271907 0.7069193279498336 -1.4410270960003857e-08 -0.09989429865041166 -2.4833000000000003 0.706920531400625 0.7069193843727646 -1.3027800896230068e-08 -0.09989433074354886 -2.4834 0.706920588471591 0.7069194407637132 -1.1652683075402681e-08 -0.09989436282694705 -2.4835 0.706920645540011 0.7069194971227676 -1.0285232428328822e-08 -0.09989439490060922 -2.4836000000000005 0.7069207026058038 0.7069195534500192 -8.925762027059414e-09 -0.09989442696453832 -2.4837000000000002 0.7069207596688849 0.706919609745563 -7.574582999887725e-09 -0.09989445901873727 -2.4838 0.706920816729167 0.706919666009497 -6.232004475838215e-09 -0.099894491063209 -2.4839 0.7069208737865589 0.7069197222419223 -4.898333504435581e-09 -0.09989452309795645 -2.484 0.7069209308409665 0.7069197784429437 -3.573874988484216e-09 -0.09989455512298263 -2.4841 0.7069209878922924 0.7069198346126695 -2.2589316112098246e-09 -0.0998945871382905 -2.4842000000000004 0.7069210449404356 0.7069198907512105 -9.538037712072955e-10 -0.09989461914388295 -2.4843 0.7069211019852925 0.7069199468586811 3.4121048608087845e-10 -0.09989465113976294 -2.4844 0.7069211590267557 0.706920002935199 1.625815540355624e-09 -0.09989468312593343 -2.4845 0.706921216064715 0.7069200589808845 2.8997182615134176e-09 -0.09989471510239734 -2.4846000000000004 0.7069212730990573 0.7069201149958615 4.162628075565777e-09 -0.09989474706915759 -2.4847 0.7069213301296657 0.7069201709802568 5.414257029691394e-09 -0.09989477902621714 -2.4848000000000003 0.7069213871564215 0.7069202269342005 6.654319865094516e-09 -0.099894810973579 -2.4849 0.7069214441792016 0.7069202828578256 7.882534075985548e-09 -0.09989484291124603 -2.485 0.7069215011978802 0.7069203387512676 9.098619975500544e-09 -0.09989487483922117 -2.4851000000000005 0.7069215582123295 0.7069203946146658 1.0302300751212357e-08 -0.09989490675750744 -2.4852000000000003 0.7069216152224176 0.7069204504481619 1.149330254059111e-08 -0.09989493866610767 -2.4853 0.7069216722280103 0.7069205062519006 1.2671354492586884e-08 -0.09989497056502487 -2.4854000000000003 0.7069217292289702 0.7069205620260296 1.383618882314086e-08 -0.09989500245426192 -2.4855 0.7069217862251573 0.7069206177706993 1.4987540868094396e-08 -0.09989503433382178 -2.4856000000000003 0.7069218432164291 0.7069206734860629 1.6125149167323105e-08 -0.09989506620370742 -2.4857000000000005 0.7069219002026397 0.7069207291722763 1.7248755498563972e-08 -0.09989509806392169 -2.4858000000000002 0.7069219571836405 0.7069207848294984 1.835810495721263e-08 -0.09989512991446757 -2.4859 0.7069220141592807 0.7069208404578906 1.94529459892831e-08 -0.09989516175534802 -2.486 0.7069220711294067 0.706920896057617 2.0533030481613423e-08 -0.09989519358656594 -2.4861000000000004 0.706922128093862 0.7069209516288444 2.1598113787886508e-08 -0.09989522540812425 -2.4862 0.7069221850524877 0.7069210071717422 2.2647954798019065e-08 -0.09989525722002594 -2.4863000000000004 0.7069222420051224 0.7069210626864819 2.3682315990203318e-08 -0.09989528902227388 -2.4864 0.706922298951602 0.706921118173238 2.47009634829487e-08 -0.09989532081487097 -2.4865 0.7069223558917599 0.7069211736321872 2.570366710100136e-08 -0.09989535259782016 -2.4866 0.7069224128254273 0.706921229063509 2.6690200395293462e-08 -0.0998953843711244 -2.4867000000000004 0.7069224697524332 0.7069212844673849 2.76603407314141e-08 -0.09989541613478663 -2.4868 0.7069225266726036 0.7069213398439986 2.8613869319099594e-08 -0.09989544788880969 -2.4869 0.7069225835857629 0.7069213951935367 2.955057126774463e-08 -0.09989547963319656 -2.487 0.7069226404917328 0.7069214505161876 3.0470235628035636e-08 -0.09989551136795016 -2.4871000000000003 0.7069226973903331 0.7069215058121422 3.137265544399248e-08 -0.09989554309307347 -2.4872 0.7069227542813808 0.7069215610815931 3.2257627806744904e-08 -0.0998955748085693 -2.4873000000000003 0.7069228111646917 0.7069216163247353 3.312495388922698e-08 -0.0998956065144406 -2.4874 0.7069228680400784 0.7069216715417661 3.397443898607577e-08 -0.0998956382106903 -2.4875 0.7069229249073526 0.7069217267328847 3.480589257781608e-08 -0.09989566989732131 -2.4876000000000005 0.7069229817663235 0.706921781898292 3.5619128358616026e-08 -0.09989570157433657 -2.4877000000000002 0.706923038616798 0.7069218370381913 3.641396427792043e-08 -0.09989573324173896 -2.4878 0.7069230954585816 0.7069218921527876 3.7190222582084154e-08 -0.09989576489953143 -2.4879000000000002 0.7069231522914777 0.7069219472422875 3.7947729861209645e-08 -0.09989579654771688 -2.488 0.7069232091152882 0.7069220023068998 3.8686317083841404e-08 -0.09989582818629819 -2.4881 0.7069232659298124 0.7069220573468351 3.940581962992573e-08 -0.09989585981527829 -2.4882000000000004 0.706923322734849 0.7069221123623053 4.010607732897464e-08 -0.09989589143466013 -2.4883 0.7069233795301946 0.7069221673535244 4.0786934496495064e-08 -0.09989592304444661 -2.4884 0.7069234363156437 0.7069222223207074 4.1448239982561086e-08 -0.09989595464464059 -2.4885 0.7069234930909899 0.7069222772640715 4.2089847177018136e-08 -0.09989598623524501 -2.4886000000000004 0.7069235498560249 0.706922332183835 4.271161405978996e-08 -0.09989601781626274 -2.4887 0.7069236066105393 0.7069223870802182 4.331340324077726e-08 -0.09989604938769679 -2.4888000000000003 0.7069236633543219 0.7069224419534419 4.389508197200076e-08 -0.09989608094954994 -2.4889 0.7069237200871596 0.7069224968037294 4.445652218229568e-08 -0.09989611250182513 -2.489 0.7069237768088397 0.7069225516313045 4.4997600506802016e-08 -0.09989614404452529 -2.4891000000000005 0.7069238335191463 0.7069226064363927 4.551819831645487e-08 -0.09989617557765335 -2.4892000000000003 0.7069238902178641 0.7069226612192201 4.601820174400528e-08 -0.09989620710121218 -2.4893 0.7069239469047746 0.7069227159800144 4.649750170136746e-08 -0.09989623861520464 -2.4894000000000003 0.70692400357966 0.7069227707190049 4.695599391778271e-08 -0.09989627011963367 -2.4895 0.7069240602423004 0.706922825436421 4.739357894155416e-08 -0.09989630161450216 -2.4896000000000003 0.7069241168924754 0.7069228801324939 4.781016217821066e-08 -0.09989633309981305 -2.4897000000000005 0.7069241735299632 0.706922934807455 4.8205653906119306e-08 -0.09989636457556916 -2.4898000000000002 0.7069242301545416 0.7069229894615375 4.85799693025063e-08 -0.09989639604177347 -2.4899 0.7069242867659872 0.7069230440949745 4.893302843998748e-08 -0.09989642749842882 -2.49 0.7069243433640757 0.7069230987080006 4.9264756331671156e-08 -0.0998964589455381 -2.4901000000000004 0.7069243999485825 0.706923153300851 4.957508292074975e-08 -0.09989649038310425 -2.4902 0.706924456519282 0.7069232078737613 4.9863943120398435e-08 -0.09989652181113015 -2.4903000000000004 0.7069245130759481 0.706923262426968 5.013127680336682e-08 -0.09989655322961868 -2.4904 0.7069245696183537 0.7069233169607079 5.037702883146922e-08 -0.0998965846385727 -2.4905 0.7069246261462717 0.7069233714752188 5.060114906425828e-08 -0.09989661603799516 -2.4906 0.7069246826594744 0.7069234259707387 5.0803592348616644e-08 -0.09989664742788891 -2.4907000000000004 0.7069247391577335 0.7069234804475059 5.0984318569063936e-08 -0.09989667880825685 -2.4908 0.7069247956408202 0.706923534905759 5.1143292618266445e-08 -0.09989671017910182 -2.4909 0.7069248521085061 0.7069235893457375 5.1280484414384375e-08 -0.09989674154042678 -2.491 0.7069249085605616 0.7069236437676807 5.1395868913214904e-08 -0.09989677289223459 -2.4911000000000003 0.7069249649967575 0.7069236981718281 5.1489426109926906e-08 -0.09989680423452817 -2.4912 0.7069250214168643 0.7069237525584193 5.156114103385678e-08 -0.09989683556731033 -2.4913000000000003 0.7069250778206525 0.7069238069276946 5.1611003757182083e-08 -0.09989686689058402 -2.4914 0.7069251342078924 0.7069238612798934 5.163900940186039e-08 -0.0998968982043521 -2.4915 0.7069251905783542 0.7069239156152556 5.16451581222821e-08 -0.09989692950861746 -2.4916000000000005 0.7069252469318084 0.706923969934021 5.1629455126087076e-08 -0.09989696080338295 -2.4917000000000002 0.7069253032680254 0.7069240242364293 5.159191065161328e-08 -0.09989699208865144 -2.4918 0.7069253595867762 0.7069240785227202 5.15325399713662e-08 -0.09989702336442591 -2.4919000000000002 0.7069254158878313 0.7069241327931325 5.1451363392018834e-08 -0.09989705463070908 -2.492 0.7069254721709621 0.7069241870479055 5.134840624053394e-08 -0.09989708588750393 -2.4921 0.7069255284359401 0.7069242412872779 5.122369885722511e-08 -0.09989711713481332 -2.4922000000000004 0.7069255846825372 0.7069242955114878 5.107727659575678e-08 -0.0998971483726401 -2.4923 0.706925640910526 0.7069243497207731 5.0909179797123394e-08 -0.09989717960098721 -2.4924 0.7069256971196793 0.706924403915371 5.071945380873133e-08 -0.09989721081985747 -2.4925 0.7069257533097703 0.7069244580955185 5.0508148934091945e-08 -0.09989724202925376 -2.4926000000000004 0.706925809480573 0.7069245122614516 5.0275320441495186e-08 -0.09989727322917896 -2.4927 0.7069258656318622 0.7069245664134058 5.0021028553601243e-08 -0.09989730441963596 -2.4928000000000003 0.7069259217634132 0.7069246205516159 4.9745338421419705e-08 -0.09989733560062754 -2.4929 0.7069259778750021 0.706924674676316 4.944832011216649e-08 -0.0998973667721567 -2.493 0.7069260339664059 0.7069247287877394 4.913004859191661e-08 -0.09989739793422624 -2.4931000000000005 0.7069260900374023 0.706924782886118 4.879060370131805e-08 -0.09989742908683899 -2.4932000000000003 0.7069261460877703 0.7069248369716838 4.843007014865286e-08 -0.0998974602299979 -2.4933 0.7069262021172891 0.7069248910446672 4.8048537475142705e-08 -0.09989749136370582 -2.4934000000000003 0.7069262581257397 0.7069249451052972 4.764610004107106e-08 -0.09989752248796557 -2.4935 0.7069263141129039 0.7069249991538027 4.722285699282347e-08 -0.09989755360278006 -2.4936000000000003 0.7069263700785644 0.7069250531904105 4.677891225247921e-08 -0.09989758470815209 -2.4937000000000005 0.7069264260225055 0.7069251072153468 4.631437447964737e-08 -0.0998976158040846 -2.4938000000000002 0.7069264819445125 0.7069251612288368 4.582935705932378e-08 -0.09989764689058042 -2.4939 0.7069265378443718 0.7069252152311034 4.5323978060257675e-08 -0.0998976779676424 -2.494 0.7069265937218713 0.7069252692223693 4.479836021066552e-08 -0.0998977090352734 -2.4941000000000004 0.7069266495768002 0.7069253232028552 4.4252630870475484e-08 -0.09989774009347625 -2.4942 0.7069267054089494 0.7069253771727806 4.368692199489821e-08 -0.0998977711422539 -2.4943 0.7069267612181109 0.7069254311323632 4.3101370122283766e-08 -0.0998978021816091 -2.4944 0.7069268170040786 0.7069254850818195 4.249611632034522e-08 -0.09989783321154475 -2.4945 0.7069268727666476 0.7069255390213646 4.187130614626e-08 -0.09989786423206373 -2.4946 0.7069269285056148 0.7069255929512117 4.1227089629322644e-08 -0.09989789524316893 -2.4947000000000004 0.7069269842207786 0.7069256468715723 4.0563621239719794e-08 -0.09989792624486313 -2.4948 0.7069270399119394 0.7069257007826559 3.9881059831284316e-08 -0.09989795723714916 -2.4949 0.7069270955788991 0.706925754684671 3.9179568613739724e-08 -0.09989798822002993 -2.495 0.7069271512214617 0.706925808577824 3.845931511800571e-08 -0.0998980191935083 -2.4951000000000003 0.7069272068394327 0.7069258624623189 3.7720471151095336e-08 -0.09989805015758706 -2.4952 0.7069272624326196 0.7069259163383586 3.696321275448167e-08 -0.09989808111226911 -2.4953000000000003 0.7069273180008321 0.7069259702061432 3.618772015899496e-08 -0.09989811205755728 -2.4954 0.7069273735438815 0.7069260240658719 3.5394177748393485e-08 -0.09989814299345443 -2.4955 0.7069274290615815 0.7069260779177409 3.458277402640375e-08 -0.0998981739199634 -2.4956000000000005 0.7069274845537474 0.7069261317619446 3.37537015403927e-08 -0.09989820483708703 -2.4957000000000003 0.7069275400201974 0.7069261855986757 3.290715686402046e-08 -0.0998982357448282 -2.4958 0.7069275954607509 0.7069262394281243 3.2043340538259746e-08 -0.09989826664318971 -2.4959000000000002 0.70692765087523 0.7069262932504782 3.1162457040170843e-08 -0.09989829753217443 -2.496 0.7069277062634594 0.7069263470659232 3.0264714699634876e-08 -0.09989832841178517 -2.4961 0.7069277616252652 0.7069264008746428 2.935032568547602e-08 -0.09989835928202478 -2.4962000000000004 0.7069278169604767 0.7069264546768183 2.8419505941276735e-08 -0.09989839014289614 -2.4963 0.706927872268925 0.7069265084726284 2.747247512813189e-08 -0.0998984209944021 -2.4964 0.7069279275504436 0.7069265622622491 2.650945658821957e-08 -0.09989845183654542 -2.4965 0.706927982804869 0.706926616045855 2.5530677273677416e-08 -0.099898482669329 -2.4966000000000004 0.7069280380320397 0.7069266698236172 2.4536367711908147e-08 -0.09989851349275569 -2.4967 0.7069280932317967 0.7069267235957046 2.3526761946598973e-08 -0.09989854430682832 -2.4968000000000004 0.7069281484039838 0.7069267773622834 2.2502097464863202e-08 -0.09989857511154965 -2.4969 0.7069282035484471 0.7069268311235175 2.146261516081105e-08 -0.09989860590692257 -2.497 0.7069282586650357 0.7069268848795681 2.0408559274834315e-08 -0.09989863669294992 -2.4971000000000005 0.7069283137536011 0.7069269386305936 1.9340177338095232e-08 -0.09989866746963454 -2.4972000000000003 0.7069283688139973 0.7069269923767496 1.8257720104004893e-08 -0.09989869823697922 -2.4973 0.7069284238460818 0.7069270461181894 1.7161441495314178e-08 -0.09989872899498684 -2.4974000000000003 0.7069284788497141 0.7069270998550632 1.6051598556408864e-08 -0.0998987597436602 -2.4975 0.7069285338247566 0.7069271535875183 1.492845137264498e-08 -0.09989879048300215 -2.4976000000000003 0.7069285887710747 0.7069272073156996 1.3792263023511275e-08 -0.09989882121301548 -2.4977000000000005 0.7069286436885367 0.7069272610397488 1.2643299514975004e-08 -0.09989885193370307 -2.4978000000000002 0.706928698577014 0.7069273147598045 1.1481829720501324e-08 -0.09989888264506773 -2.4979 0.7069287534363802 0.7069273684760031 1.0308125316868533e-08 -0.09989891334711229 -2.498 0.7069288082665126 0.7069274221884774 9.122460717381209e-09 -0.09989894403983955 -2.4981000000000004 0.7069288630672911 0.7069274758973572 7.925113016359064e-09 -0.09989897472325235 -2.4982 0.7069289178385988 0.7069275296027697 6.716361911941748e-09 -0.09989900539735352 -2.4983 0.7069289725803216 0.706927583304839 5.496489654914505e-09 -0.0998990360621459 -2.4984 0.7069290272923484 0.7069276370036857 4.2657809697782545e-09 -0.09989906671763225 -2.4985 0.7069290819745717 0.7069276906994278 3.0245229975037202e-09 -0.09989909736381547 -2.4986 0.7069291366268867 0.7069277443921802 1.7730052200709556e-09 -0.09989912800069833 -2.4987000000000004 0.7069291912491918 0.706927798082054 5.115194066929174e-10 -0.09989915862828368 -2.4988 0.7069292458413885 0.7069278517691578 -7.596404668491763e-10 -0.0998991892465743 -2.4989 0.7069293004033816 0.7069279054535972 -2.040178284125338e-09 -0.09989921985557305 -2.499 0.7069293549350792 0.7069279591354738 -3.3297958522415794e-09 -0.09989925045528275 -2.4991000000000003 0.7069294094363925 0.7069280128148862 -4.628192979035106e-09 -0.09989928104570618 -2.4992 0.7069294639072357 0.7069280664919301 -5.9350675311875545e-09 -0.09989931162684615 -2.4993000000000003 0.7069295183475263 0.7069281201666978 -7.250115518359079e-09 -0.09989934219870544 -2.4994 0.7069295727571858 0.7069281738392785 -8.573031152168953e-09 -0.09989937276128699 -2.4995 0.7069296271361384 0.7069282275097575 -9.903506925992844e-09 -0.09989940331459352 -2.4996000000000005 0.7069296814843116 0.7069282811782172 -1.1241233680882312e-08 -0.09989943385862783 -2.4997000000000003 0.7069297358016362 0.7069283348447367 -1.2585900677989509e-08 -0.09989946439339281 -2.4998 0.7069297900880469 0.7069283885093915 -1.393719567272661e-08 -0.09989949491889119 -2.4999000000000002 0.706929844343481 0.7069284421722539 -1.529480498849156e-08 -0.09989952543512579 -2.5 0.7069298985678799 0.7069284958333932 -1.6658413582587572e-08 -0.09989955594209948 -2.5001 0.7069299527611876 0.7069285494928742 -1.802770512905616e-08 -0.099899586439815 -2.5002000000000004 0.7069300069233524 0.7069286031507594 -1.940236208416296e-08 -0.0998996169282752 -2.5003 0.7069300610543252 0.7069286568071074 -2.0782065762291885e-08 -0.09989964740748282 -2.5004 0.7069301151540612 0.706928710461973 -2.2166496411405584e-08 -0.09989967787744074 -2.5005 0.7069301692225183 0.7069287641154085 -2.3555333285036478e-08 -0.09989970833815175 -2.5006000000000004 0.7069302232596583 0.706928817767462 -2.4948254720782992e-08 -0.09989973878961864 -2.5007 0.706930277265446 0.7069288714181781 -2.6344938207096408e-08 -0.09989976923184418 -2.5008000000000004 0.7069303312398503 0.7069289250675983 -2.7745060463511828e-08 -0.09989979966483123 -2.5009 0.706930385182843 0.7069289787157604 -2.9148297516542326e-08 -0.09989983008858257 -2.501 0.7069304390943998 0.706929032362699 -3.055432477058577e-08 -0.09989986050310101 -2.5011000000000005 0.7069304929744998 0.7069290860084448 -3.196281708446949e-08 -0.09989989090838935 -2.5012000000000003 0.7069305468231254 0.7069291396530253 -3.337344884864549e-08 -0.09989992130445037 -2.5013 0.7069306006402624 0.7069291932964642 -3.478589405783196e-08 -0.09989995169128685 -2.5014000000000003 0.7069306544259005 0.706929246938782 -3.619982638604011e-08 -0.0998999820689016 -2.5015 0.7069307081800329 0.7069293005799955 -3.7614919264528264e-08 -0.09990001243729742 -2.5016000000000003 0.7069307619026558 0.706929354220118 -3.9030845955093964e-08 -0.09990004279647713 -2.5017000000000005 0.7069308155937697 0.7069294078591597 -4.044727962634756e-08 -0.09990007314644353 -2.5018000000000002 0.7069308692533778 0.7069294614971264 -4.186389342830535e-08 -0.09990010348719937 -2.5019 0.7069309228814873 0.7069295151340215 -4.328036056970672e-08 -0.09990013381874746 -2.502 0.7069309764781087 0.7069295687698436 -4.469635439160438e-08 -0.09990016414109057 -2.5021000000000004 0.7069310300432559 0.7069296224045891 -4.6111548442377606e-08 -0.0999001944542315 -2.5022 0.7069310835769468 0.70692967603825 -4.752561655368059e-08 -0.09990022475817306 -2.5023 0.7069311370792024 0.706929729670815 -4.8938232917244626e-08 -0.09990025505291802 -2.5024 0.7069311905500473 0.7069297833022699 -5.034907215684201e-08 -0.0999002853384692 -2.5025 0.7069312439895094 0.7069298369325959 -5.1757809404247984e-08 -0.09990031561482937 -2.5026 0.7069312973976202 0.706929890561772 -5.316412037600221e-08 -0.0999003458820013 -2.5027000000000004 0.7069313507744152 0.7069299441897723 -5.456768144458668e-08 -0.09990037613998781 -2.5028 0.7069314041199323 0.7069299978165686 -5.596816971616299e-08 -0.09990040638879165 -2.5029 0.7069314574342136 0.706930051442129 -5.736526310267179e-08 -0.09990043662841563 -2.503 0.7069315107173046 0.7069301050664174 -5.8758640396859574e-08 -0.09990046685886249 -2.5031000000000003 0.7069315639692539 0.7069301586893953 -6.01479813468718e-08 -0.09990049708013507 -2.5032 0.7069316171901141 0.70693021231102 -6.153296672802705e-08 -0.09990052729223606 -2.5033000000000003 0.7069316703799403 0.7069302659312461 -6.291327841415756e-08 -0.09990055749516835 -2.5034 0.7069317235387921 0.7069303195500242 -6.428859945740648e-08 -0.0999005876889347 -2.5035 0.7069317766667317 0.7069303731673015 -6.56586141580505e-08 -0.09990061787353782 -2.5036000000000005 0.706931829763825 0.7069304267830221 -6.702300812955198e-08 -0.09990064804898055 -2.5037000000000003 0.7069318828301409 0.7069304803971266 -6.838146838399409e-08 -0.09990067821526565 -2.5038 0.7069319358657522 0.7069305340095526 -6.973368338932667e-08 -0.09990070837239588 -2.5039000000000002 0.7069319888707344 0.7069305876202341 -7.107934315480138e-08 -0.09990073852037404 -2.504 0.7069320418451672 0.7069306412291014 -7.241813929298804e-08 -0.09990076865920289 -2.5041 0.7069320947891327 0.706930694836082 -7.374976509480144e-08 -0.09990079878888522 -2.5042000000000004 0.7069321477027168 0.7069307484411 -7.507391559238505e-08 -0.09990082890942381 -2.5043 0.7069322005860081 0.7069308020440767 -7.639028763977568e-08 -0.09990085902082142 -2.5044 0.7069322534390992 0.7069308556449292 -7.769857997882296e-08 -0.09990088912308082 -2.5045 0.7069323062620851 0.7069309092435718 -7.899849329643521e-08 -0.09990091921620471 -2.5046000000000004 0.7069323590550647 0.706930962839916 -8.0289730312183e-08 -0.09990094930019595 -2.5047 0.7069324118181397 0.7069310164338698 -8.157199583424396e-08 -0.09990097937505733 -2.5048000000000004 0.7069324645514151 0.7069310700253382 -8.284499682618962e-08 -0.09990100944079158 -2.5049 0.7069325172549985 0.7069311236142226 -8.41084424807112e-08 -0.0999010394974014 -2.505 0.7069325699290014 0.7069311772004221 -8.536204428206962e-08 -0.09990106954488964 -2.5051000000000005 0.7069326225735377 0.7069312307838322 -8.660551607461708e-08 -0.09990109958325905 -2.5052000000000003 0.7069326751887249 0.7069312843643452 -8.783857411570617e-08 -0.09990112961251235 -2.5053 0.7069327277746831 0.7069313379418511 -8.906093716329333e-08 -0.09990115963265238 -2.5054000000000003 0.7069327803315353 0.7069313915162362 -9.027232652104172e-08 -0.09990118964368183 -2.5055 0.7069328328594082 0.7069314450873841 -9.147246610510806e-08 -0.09990121964560354 -2.5056000000000003 0.7069328853584304 0.7069314986551753 -9.266108251786837e-08 -0.09990124963842018 -2.5057000000000005 0.7069329378287341 0.706931552219488 -9.38379050964902e-08 -0.09990127962213456 -2.5058000000000002 0.7069329902704542 0.7069316057801968 -9.500266598318902e-08 -0.09990130959674945 -2.5059 0.7069330426837286 0.7069316593371737 -9.615510017900453e-08 -0.09990133956226761 -2.506 0.7069330950686975 0.7069317128902879 -9.729494561579177e-08 -0.09990136951869175 -2.5061000000000004 0.7069331474255045 0.706931766439406 -9.842194320045655e-08 -0.09990139946602468 -2.5062 0.7069331997542956 0.7069318199843917 -9.953583688781381e-08 -0.09990142940426917 -2.5063 0.7069332520552194 0.706931873525106 -1.006363737291599e-07 -0.09990145933342792 -2.5064 0.7069333043284274 0.7069319270614071 -1.0172330392951845e-07 -0.0999014892535037 -2.5065 0.7069333565740736 0.7069319805931505 -1.0279638092136612e-07 -0.09990151916449926 -2.5066 0.7069334087923149 0.7069320341201897 -1.0385536139238816e-07 -0.09990154906641738 -2.5067000000000004 0.7069334609833104 0.7069320876423749 -1.0490000536267363e-07 -0.0999015789592608 -2.5068 0.7069335131472219 0.706932141159554 -1.0593007622374667e-07 -0.09990160884303223 -2.5069 0.7069335652842137 0.7069321946715726 -1.0694534081402696e-07 -0.09990163871773448 -2.507 0.7069336173944526 0.7069322481782736 -1.079455694439832e-07 -0.09990166858337027 -2.5071000000000003 0.7069336694781079 0.7069323016794977 -1.0893053597159363e-07 -0.09990169843994237 -2.5072 0.7069337215353508 0.7069323551750828 -1.0990001783790782e-07 -0.09990172828745351 -2.5073000000000003 0.7069337735663552 0.7069324086648648 -1.1085379612515989e-07 -0.0999017581259064 -2.5074 0.7069338255712977 0.7069324621486777 -1.1179165560620818e-07 -0.09990178795530386 -2.5075 0.7069338775503565 0.7069325156263521 -1.1271338477836235e-07 -0.09990181777564862 -2.5076000000000005 0.7069339295037121 0.7069325690977173 -1.1361877593971115e-07 -0.09990184758694337 -2.5077000000000003 0.7069339814315478 0.7069326225626003 -1.1450762520646973e-07 -0.09990187738919093 -2.5078 0.7069340333340484 0.7069326760208253 -1.1537973259104217e-07 -0.09990190718239396 -2.5079000000000002 0.706934085211401 0.7069327294722154 -1.1623490200202147e-07 -0.09990193696655526 -2.508 0.7069341370637948 0.706932782916591 -1.1707294133266044e-07 -0.09990196674167759 -2.5081 0.7069341888914209 0.7069328363537705 -1.1789366247821897e-07 -0.09990199650776362 -2.5082000000000004 0.7069342406944725 0.7069328897835707 -1.1869688139320989e-07 -0.09990202626481616 -2.5083 0.7069342924731447 0.706932943205806 -1.1948241810874616e-07 -0.0999020560128379 -2.5084 0.7069343442276343 0.7069329966202893 -1.2025009680539933e-07 -0.09990208575183163 -2.5085 0.7069343959581402 0.7069330500268316 -1.209997458201384e-07 -0.09990211548180004 -2.5086000000000004 0.7069344476648631 0.7069331034252417 -1.217311977209229e-07 -0.09990214520274587 -2.5087 0.7069344993480051 0.706933156815327 -1.2244428930149875e-07 -0.09990217491467188 -2.5088000000000004 0.7069345510077703 0.7069332101968933 -1.2313886165599142e-07 -0.09990220461758077 -2.5089 0.7069346026443641 0.7069332635697447 -1.2381476019451831e-07 -0.0999022343114753 -2.509 0.7069346542579943 0.7069333169336833 -1.2447183467614864e-07 -0.09990226399635821 -2.5091000000000006 0.7069347058488693 0.7069333702885103 -1.251099392505367e-07 -0.0999022936722322 -2.5092000000000003 0.7069347574171997 0.7069334236340249 -1.2572893248741224e-07 -0.09990232333910004 -2.5093 0.706934808963197 0.7069334769700248 -1.2632867740607068e-07 -0.09990235299696446 -2.5094000000000003 0.7069348604870747 0.7069335302963066 -1.2690904150833293e-07 -0.09990238264582812 -2.5095 0.7069349119890472 0.7069335836126651 -1.2746989679936205e-07 -0.09990241228569378 -2.5096000000000003 0.7069349634693305 0.7069336369188944 -1.2801111983623548e-07 -0.09990244191656422 -2.5097000000000005 0.7069350149281416 0.7069336902147869 -1.2853259173314924e-07 -0.0999024715384421 -2.5098000000000003 0.7069350663656992 0.7069337435001338 -1.2903419819437767e-07 -0.0999025011513302 -2.5099 0.7069351177822226 0.7069337967747251 -1.29515829542029e-07 -0.09990253075523123 -2.51 0.7069351691779326 0.7069338500383502 -1.2997738074206622e-07 -0.09990256035014794 -2.5101000000000004 0.7069352205530508 0.7069339032907965 -1.304187514164501e-07 -0.09990258993608296 -2.5102 0.7069352719077997 0.7069339565318512 -1.3083984588650732e-07 -0.09990261951303907 -2.5103 0.7069353232424036 0.7069340097612999 -1.3124057316946103e-07 -0.09990264908101901 -2.5104 0.706935374557087 0.706934062978928 -1.3162084699230858e-07 -0.0999026786400255 -2.5105 0.7069354258520751 0.7069341161845193 -1.3198058586467998e-07 -0.09990270819006125 -2.5106 0.7069354771275946 0.7069341693778572 -1.3231971301985723e-07 -0.09990273773112897 -2.5107000000000004 0.7069355283838724 0.7069342225587241 -1.3263815648763277e-07 -0.0999027672632314 -2.5108 0.7069355796211365 0.7069342757269022 -1.3293584908216638e-07 -0.09990279678637129 -2.5109 0.7069356308396151 0.7069343288821723 -1.3321272843494492e-07 -0.09990282630055129 -2.511 0.7069356820395374 0.7069343820243151 -1.33468736984374e-07 -0.09990285580577415 -2.5111000000000003 0.7069357332211328 0.7069344351531104 -1.3370382200526831e-07 -0.09990288530204255 -2.5112 0.7069357843846317 0.706934488268338 -1.3391793561752519e-07 -0.09990291478935927 -2.5113000000000003 0.7069358355302646 0.7069345413697767 -1.3411103478265518e-07 -0.09990294426772699 -2.5114 0.7069358866582625 0.7069345944572052 -1.3428308134021127e-07 -0.0999029737371484 -2.5115 0.7069359377688567 0.7069346475304016 -1.3443404198350273e-07 -0.09990300319762623 -2.5116000000000005 0.7069359888622788 0.706934700589144 -1.3456388827173815e-07 -0.09990303264916317 -2.5117000000000003 0.7069360399387608 0.7069347536332101 -1.3467259665778109e-07 -0.09990306209176202 -2.5118 0.7069360909985347 0.7069348066623776 -1.3476014848294582e-07 -0.09990309152542542 -2.5119000000000002 0.7069361420418325 0.7069348596764237 -1.3482652995618072e-07 -0.09990312095015604 -2.512 0.7069361930688867 0.7069349126751256 -1.3487173218008908e-07 -0.09990315036595665 -2.5121 0.7069362440799296 0.7069349656582609 -1.3489575114399022e-07 -0.09990317977282995 -2.5122000000000004 0.7069362950751934 0.7069350186256065 -1.348985877308584e-07 -0.09990320917077863 -2.5123 0.7069363460549105 0.70693507157694 -1.3488024769997553e-07 -0.0999032385598054 -2.5124 0.7069363970193128 0.7069351245120387 -1.3484074169733962e-07 -0.09990326793991294 -2.5125 0.7069364479686322 0.7069351774306802 -1.3478008524872576e-07 -0.099903297311104 -2.5126000000000004 0.7069364989031006 0.7069352303326428 -1.3469829876142092e-07 -0.09990332667338128 -2.5127 0.7069365498229496 0.7069352832177044 -1.3459540749473364e-07 -0.09990335602674749 -2.5128000000000004 0.7069366007284097 0.7069353360856432 -1.3447144157560653e-07 -0.09990338537120524 -2.5129 0.7069366516197121 0.7069353889362383 -1.343264359864732e-07 -0.09990341470675734 -2.513 0.706936702497087 0.7069354417692691 -1.3416043053576798e-07 -0.0999034440334065 -2.5131000000000006 0.7069367533607638 0.7069354945845151 -1.339734698874162e-07 -0.09990347335115529 -2.5132000000000003 0.7069368042109723 0.7069355473817567 -1.337656035070578e-07 -0.09990350266000653 -2.5133 0.7069368550479407 0.706935600160775 -1.3353688567765976e-07 -0.09990353195996288 -2.5134000000000003 0.7069369058718973 0.7069356529213513 -1.3328737546655645e-07 -0.09990356125102703 -2.5135 0.706936956683069 0.7069357056632681 -1.3301713672544957e-07 -0.09990359053320166 -2.5136000000000003 0.7069370074816828 0.7069357583863082 -1.3272623806785677e-07 -0.09990361980648953 -2.5137000000000005 0.7069370582679642 0.7069358110902555 -1.324147528448255e-07 -0.09990364907089326 -2.5138000000000003 0.7069371090421381 0.7069358637748946 -1.3208275914319834e-07 -0.09990367832641561 -2.5139 0.7069371598044284 0.7069359164400107 -1.3173033975438786e-07 -0.09990370757305916 -2.514 0.7069372105550584 0.7069359690853908 -1.313575821466212e-07 -0.09990373681082673 -2.5141000000000004 0.7069372612942503 0.7069360217108218 -1.3096457846147047e-07 -0.09990376603972094 -2.5142 0.7069373120222249 0.7069360743160928 -1.3055142548089316e-07 -0.09990379525974455 -2.5143 0.706937362739202 0.7069361269009932 -1.301182246046806e-07 -0.09990382447090018 -2.5144 0.7069374134454005 0.7069361794653133 -1.2966508183137604e-07 -0.09990385367319049 -2.5145 0.7069374641410378 0.7069362320088454 -1.2919210770970246e-07 -0.09990388286661821 -2.5146 0.7069375148263305 0.7069362845313827 -1.2869941734376666e-07 -0.09990391205118604 -2.5147000000000004 0.7069375655014936 0.7069363370327197 -1.2818713035142593e-07 -0.09990394122689669 -2.5148 0.7069376161667407 0.7069363895126523 -1.2765537083132827e-07 -0.0999039703937528 -2.5149 0.706937666822284 0.7069364419709774 -1.2710426733342217e-07 -0.09990399955175708 -2.515 0.7069377174683347 0.7069364944074937 -1.265339528277315e-07 -0.0999040287009122 -2.5151000000000003 0.7069377681051019 0.7069365468220017 -1.2594456468006943e-07 -0.09990405784122089 -2.5152 0.7069378187327935 0.7069365992143026 -1.2533624461907866e-07 -0.09990408697268574 -2.5153000000000003 0.7069378693516157 0.7069366515841999 -1.2470913869112865e-07 -0.0999041160953095 -2.5154 0.7069379199617731 0.7069367039314982 -1.2406339722215165e-07 -0.09990414520909484 -2.5155 0.7069379705634692 0.706936756256004 -1.2339917480549967e-07 -0.09990417431404441 -2.5156000000000005 0.7069380211569045 0.7069368085575258 -1.227166302446986e-07 -0.09990420341016092 -2.5157000000000003 0.7069380717422791 0.7069368608358733 -1.2201592652395787e-07 -0.09990423249744701 -2.5158 0.7069381223197901 0.7069369130908583 -1.212972307665372e-07 -0.09990426157590537 -2.5159000000000002 0.7069381728896342 0.7069369653222946 -1.2056071419137837e-07 -0.09990429064553874 -2.516 0.7069382234520047 0.7069370175299974 -1.198065520749414e-07 -0.09990431970634973 -2.5161000000000002 0.7069382740070939 0.7069370697137844 -1.1903492370957114e-07 -0.09990434875834103 -2.5162000000000004 0.7069383245550916 0.706937121873475 -1.1824601236880283e-07 -0.09990437780151531 -2.5163 0.7069383750961862 0.7069371740088908 -1.1744000525358567e-07 -0.09990440683587529 -2.5164 0.7069384256305633 0.7069372261198547 -1.1661709345238414e-07 -0.09990443586142356 -2.5165 0.706938476158407 0.7069372782061928 -1.1577747189434051e-07 -0.09990446487816285 -2.5166000000000004 0.7069385266798989 0.7069373302677326 -1.1492133930243731e-07 -0.09990449388609579 -2.5167 0.7069385771952187 0.7069373823043041 -1.1404889815186392e-07 -0.09990452288522508 -2.5168000000000004 0.7069386277045437 0.7069374343157395 -1.1316035460756657e-07 -0.09990455187555344 -2.5169 0.7069386782080491 0.7069374863018729 -1.1225591849996219e-07 -0.09990458085708347 -2.517 0.7069387287059075 0.7069375382625411 -1.1133580325208003e-07 -0.0999046098298178 -2.5171000000000006 0.7069387791982891 0.706937590197583 -1.1040022583966302e-07 -0.09990463879375916 -2.5172000000000003 0.7069388296853625 0.7069376421068403 -1.0944940674433024e-07 -0.09990466774891024 -2.5173 0.7069388801672927 0.7069376939901566 -1.0848356989459629e-07 -0.09990469669527366 -2.5174000000000003 0.7069389306442433 0.7069377458473782 -1.0750294260775811e-07 -0.09990472563285208 -2.5175 0.7069389811163749 0.7069377976783537 -1.0650775555780256e-07 -0.0999047545616482 -2.5176000000000003 0.7069390315838457 0.7069378494829344 -1.0549824269734387e-07 -0.09990478348166464 -2.5177000000000005 0.7069390820468113 0.706937901260974 -1.0447464121078609e-07 -0.09990481239290405 -2.5178000000000003 0.7069391325054248 0.706937953012329 -1.0343719146835295e-07 -0.09990484129536914 -2.5179 0.7069391829598366 0.7069380047368583 -1.0238613694889265e-07 -0.09990487018906254 -2.518 0.7069392334101945 0.7069380564344236 -1.0132172420778546e-07 -0.09990489907398695 -2.5181000000000004 0.7069392838566435 0.7069381081048892 -1.0024420280495272e-07 -0.09990492795014498 -2.5182 0.7069393342993261 0.706938159748122 -9.91538252467436e-08 -0.09990495681753928 -2.5183 0.7069393847383818 0.7069382113639922 -9.805084692521976e-08 -0.09990498567617258 -2.5184 0.7069394351739473 0.7069382629523722 -9.693552606351158e-08 -0.0999050145260475 -2.5185 0.706939485606157 0.7069383145131372 -9.580812365510283e-08 -0.09990504336716668 -2.5186 0.706939536035142 0.7069383660461654 -9.466890340311535e-08 -0.0999050721995328 -2.5187000000000004 0.7069395864610302 0.706938417551338 -9.35181316439812e-08 -0.09990510102314845 -2.5188 0.7069396368839473 0.706938469028539 -9.235607731448298e-08 -0.09990512983801635 -2.5189 0.7069396873040162 0.7069385204776553 -9.118301186154809e-08 -0.09990515864413918 -2.519 0.706939737721356 0.7069385718985766 -8.999920919714605e-08 -0.09990518744151952 -2.5191000000000003 0.706939788136083 0.7069386232911956 -8.880494562282792e-08 -0.09990521623016002 -2.5192 0.7069398385483114 0.7069386746554084 -8.760049976554163e-08 -0.09990524501006337 -2.5193000000000003 0.7069398889581515 0.7069387259911137 -8.638615252298809e-08 -0.09990527378123223 -2.5194 0.7069399393657108 0.7069387772982132 -8.516218698469136e-08 -0.09990530254366918 -2.5195 0.7069399897710935 0.7069388285766118 -8.392888838255896e-08 -0.09990533129737691 -2.5196000000000005 0.7069400401744015 0.7069388798262177 -8.268654400674785e-08 -0.09990536004235806 -2.5197000000000003 0.7069400905757327 0.7069389310469422 -8.143544315102058e-08 -0.09990538877861531 -2.5198 0.7069401409751824 0.7069389822386991 -8.017587703815221e-08 -0.09990541750615128 -2.5199000000000003 0.7069401913728424 0.7069390334014061 -7.890813875748026e-08 -0.09990544622496861 -2.52 0.7069402417688013 0.7069390845349837 -7.763252319551578e-08 -0.09990547493506993 -2.5201000000000002 0.7069402921631451 0.7069391356393556 -7.634932696048286e-08 -0.09990550363645793 -2.5202000000000004 0.7069403425559561 0.706939186714449 -7.505884832594012e-08 -0.09990553232913521 -2.5203 0.7069403929473131 0.7069392377601936 -7.376138715358554e-08 -0.09990556101310441 -2.5204 0.7069404433372926 0.7069392887765231 -7.24572448238675e-08 -0.09990558968836818 -2.5205 0.7069404937259669 0.7069393397633741 -7.114672416486112e-08 -0.09990561835492917 -2.5206000000000004 0.7069405441134056 0.7069393907206869 -6.983012938851715e-08 -0.09990564701279003 -2.5207 0.7069405944996745 0.706939441648404 -6.850776601303316e-08 -0.09990567566195335 -2.5208000000000004 0.7069406448848368 0.7069394925464725 -6.717994079389819e-08 -0.09990570430242182 -2.5209 0.7069406952689516 0.7069395434148421 -6.584696165320286e-08 -0.09990573293419802 -2.521 0.7069407456520753 0.706939594253466 -6.450913761025037e-08 -0.09990576155728462 -2.5211000000000006 0.7069407960342609 0.7069396450623003 -6.316677870913182e-08 -0.09990579017168424 -2.5212000000000003 0.7069408464155575 0.7069396958413052 -6.182019594369939e-08 -0.09990581877739954 -2.5213 0.7069408967960115 0.7069397465904439 -6.046970119251427e-08 -0.09990584737443312 -2.5214000000000003 0.7069409471756659 0.7069397973096826 -5.9115607135146186e-08 -0.09990587596278766 -2.5215 0.7069409975545597 0.7069398479989917 -5.775822719059076e-08 -0.09990590454246578 -2.5216000000000003 0.7069410479327293 0.7069398986583438 -5.6397875439640616e-08 -0.09990593311347006 -2.5217 0.7069410983102071 0.7069399492877161 -5.503486655441224e-08 -0.09990596167580316 -2.5218000000000003 0.7069411486870226 0.7069399998870884 -5.36695157244034e-08 -0.09990599022946772 -2.5219 0.7069411990632016 0.7069400504564443 -5.230213858450211e-08 -0.09990601877446642 -2.522 0.7069412494387665 0.7069401009957703 -5.0933051140176697e-08 -0.09990604731080177 -2.5221000000000005 0.7069412998137363 0.7069401515050566 -4.9562569695267913e-08 -0.09990607583847644 -2.5222 0.706941350188127 0.7069402019842969 -4.8191010780323194e-08 -0.09990610435749309 -2.5223 0.7069414005619507 0.7069402524334885 -4.68186910788709e-08 -0.09990613286785432 -2.5224 0.7069414509352163 0.7069403028526315 -4.54459273528272e-08 -0.09990616136956278 -2.5225 0.7069415013079294 0.7069403532417298 -4.407303637139954e-08 -0.09990618986262106 -2.5226 0.7069415516800919 0.7069404036007905 -4.270033483730665e-08 -0.09990621834703182 -2.5227000000000004 0.7069416020517028 0.7069404539298243 -4.1328139313350984e-08 -0.09990624682279768 -2.5228 0.7069416524227565 0.7069405042288454 -3.995676615064451e-08 -0.0999062752899212 -2.5229 0.7069417027932459 0.7069405544978709 -3.858653141344641e-08 -0.09990630374840508 -2.523 0.706941753163159 0.7069406047369217 -3.721775080896099e-08 -0.0999063321982519 -2.5231000000000003 0.706941803532481 0.7069406549460218 -3.585073961103694e-08 -0.09990636063946425 -2.5232 0.7069418539011936 0.706940705125199 -3.448581259370576e-08 -0.0999063890720448 -2.5233000000000003 0.7069419042692751 0.706940755274484 -3.31232839516013e-08 -0.0999064174959961 -2.5234 0.7069419546367003 0.7069408053939112 -3.176346723143819e-08 -0.09990644591132085 -2.5235 0.7069420050034411 0.7069408554835184 -3.040667526251449e-08 -0.0999064743180216 -2.5236000000000005 0.7069420553694656 0.7069409055433464 -2.905322007886596e-08 -0.09990650271610102 -2.5237000000000003 0.7069421057347389 0.7069409555734394 -2.770341284976871e-08 -0.09990653110556166 -2.5238 0.7069421560992224 0.7069410055738454 -2.635756381121762e-08 -0.0999065594864062 -2.5239000000000003 0.7069422064628744 0.706941055544615 -2.501598218981535e-08 -0.09990658785863718 -2.524 0.7069422568256502 0.7069411054858028 -2.367897613706968e-08 -0.0999066162222573 -2.5241000000000002 0.706942307187501 0.7069411553974665 -2.2346852654366728e-08 -0.09990664457726915 -2.5242000000000004 0.7069423575483752 0.7069412052796665 -2.101991752401569e-08 -0.09990667292367528 -2.5243 0.7069424079082182 0.7069412551324672 -1.9698475237257818e-08 -0.09990670126147833 -2.5244 0.7069424582669717 0.7069413049559361 -1.8382828927479555e-08 -0.09990672959068092 -2.5245 0.7069425086245742 0.7069413547501435 -1.7073280301257293e-08 -0.09990675791128567 -2.5246000000000004 0.7069425589809613 0.7069414045151633 -1.577012956376425e-08 -0.09990678622329513 -2.5247 0.7069426093360651 0.7069414542510727 -1.4473675357187799e-08 -0.09990681452671196 -2.5248000000000004 0.7069426596898145 0.7069415039579519 -1.3184214687437384e-08 -0.09990684282153876 -2.5249 0.7069427100421355 0.7069415536358841 -1.1902042856490325e-08 -0.09990687110777813 -2.525 0.7069427603929508 0.7069416032849561 -1.0627453396472308e-08 -0.09990689938543265 -2.5251000000000006 0.7069428107421796 0.7069416529052577 -9.36073800070214e-09 -0.09990692765450498 -2.5252000000000003 0.7069428610897386 0.7069417024968812 -8.102186456471205e-09 -0.09990695591499765 -2.5253 0.7069429114355412 0.7069417520599227 -6.8520865847618295e-09 -0.09990698416691333 -2.5254000000000003 0.7069429617794976 0.7069418015944813 -5.610724170858339e-09 -0.0999070124102546 -2.5255 0.706943012121515 0.7069418511006584 -4.378382889753951e-09 -0.09990704064502398 -2.5256000000000003 0.7069430624614976 0.7069419005785597 -3.15534425844588e-09 -0.09990706887122418 -2.5257 0.7069431127993464 0.7069419500282927 -1.9418875552706938e-09 -0.09990709708885771 -2.5258000000000003 0.7069431631349601 0.7069419994499685 -7.382897730667803e-10 -0.09990712529792722 -2.5259 0.7069432134682336 0.706942048843701 4.551744623576548e-10 -0.09990715349843532 -2.526 0.7069432637990594 0.7069420982096071 1.6382329399294848e-09 -0.09990718169038453 -2.5261000000000005 0.7069433141273269 0.7069421475478064 2.8106159335669623e-09 -0.09990720987377749 -2.5262000000000002 0.706943364452923 0.7069421968584215 3.97205625769087e-09 -0.09990723804861684 -2.5263 0.7069434147757314 0.7069422461415779 5.1222893366134614e-09 -0.09990726621490516 -2.5264 0.7069434650956328 0.7069422953974038 6.261053260049609e-09 -0.09990729437264503 -2.5265 0.7069435154125054 0.7069423446260302 7.388088835158513e-09 -0.09990732252183901 -2.5266 0.7069435657262249 0.7069423938275907 8.50313965853472e-09 -0.09990735066248971 -2.5267000000000004 0.7069436160366639 0.706942443002222 9.605952170851917e-09 -0.09990737879459977 -2.5268 0.7069436663436924 0.7069424921500629 1.0696275708037273e-08 -0.0999074069181717 -2.5269 0.7069437166471775 0.7069425412712553 1.1773862566323567e-08 -0.09990743503320808 -2.527 0.7069437669469844 0.7069425903659439 1.2838468049086726e-08 -0.09990746313971156 -2.5271000000000003 0.706943817242975 0.7069426394342753 1.3889850530163228e-08 -0.09990749123768473 -2.5272 0.7069438675350088 0.7069426884763992 1.492777151196334e-08 -0.09990751932713014 -2.5273000000000003 0.7069439178229431 0.7069427374924679 1.595199566710448e-08 -0.0999075474080504 -2.5274 0.7069439681066323 0.7069427864826359 1.6962290901728627e-08 -0.09990757548044805 -2.5275 0.7069440183859284 0.7069428354470602 1.795842840494194e-08 -0.09990760354432572 -2.5276000000000005 0.7069440686606814 0.7069428843859002 1.8940182700856456e-08 -0.09990763159968602 -2.5277000000000003 0.7069441189307386 0.7069429332993178 1.9907331701499165e-08 -0.0999076596465315 -2.5278 0.7069441691959448 0.7069429821874769 2.0859656748445365e-08 -0.09990768768486472 -2.5279000000000003 0.7069442194561426 0.7069430310505442 2.1796942675268716e-08 -0.09990771571468826 -2.528 0.7069442697111726 0.7069430798886882 2.271897784830723e-08 -0.0999077437360047 -2.5281000000000002 0.7069443199608729 0.7069431287020802 2.3625554214368183e-08 -0.09990777174881664 -2.5282000000000004 0.7069443702050797 0.706943177490893 2.4516467349300353e-08 -0.09990779975312668 -2.5283 0.7069444204436264 0.7069432262553019 2.5391516498760036e-08 -0.0999078277489373 -2.5284 0.706944470676345 0.7069432749954847 2.6250504638059002e-08 -0.09990785573625123 -2.5285 0.7069445209030654 0.7069433237116207 2.7093238501654793e-08 -0.09990788371507098 -2.5286000000000004 0.7069445711236151 0.7069433724038909 2.791952863172298e-08 -0.0999079116853991 -2.5287 0.7069446213378192 0.7069434210724795 2.872918942325997e-08 -0.09990793964723818 -2.5288000000000004 0.7069446715455019 0.7069434697175718 2.9522039157042768e-08 -0.09990796760059081 -2.5289 0.706944721746485 0.7069435183393549 3.029790004993593e-08 -0.09990799554545957 -2.529 0.7069447719405882 0.7069435669380177 3.105659829132079e-08 -0.09990802348184696 -2.5291000000000006 0.7069448221276295 0.7069436155137515 3.1797964086463515e-08 -0.09990805140975559 -2.5292000000000003 0.7069448723074256 0.7069436640667492 3.252183168080125e-08 -0.09990807932918808 -2.5293 0.7069449224797909 0.7069437125972051 3.322803941198382e-08 -0.09990810724014693 -2.5294 0.7069449726445381 0.7069437611053155 3.391642973936404e-08 -0.09990813514263475 -2.5295 0.7069450228014788 0.7069438095912783 3.4586849278692156e-08 -0.09990816303665409 -2.5296000000000003 0.7069450729504223 0.7069438580552927 3.523914884027979e-08 -0.09990819092220751 -2.5297 0.7069451230911772 0.7069439064975598 3.5873183449816604e-08 -0.09990821879929761 -2.5298000000000003 0.7069451732235499 0.7069439549182821 3.648881239694257e-08 -0.09990824666792696 -2.5299 0.7069452233473454 0.7069440033176635 3.7085899264738265e-08 -0.09990827452809811 -2.53 0.7069452734623675 0.7069440516959091 3.766431194707209e-08 -0.09990830237981357 -2.5301000000000005 0.7069453235684187 0.7069441000532259 3.8223922688498946e-08 -0.09990833022307599 -2.5302000000000002 0.7069453736653 0.706944148389822 3.8764608103342146e-08 -0.09990835805788789 -2.5303 0.706945423752811 0.7069441967059064 3.928624921385737e-08 -0.09990838588425185 -2.5304 0.7069454738307506 0.7069442450016894 3.978873146931461e-08 -0.09990841370217039 -2.5305 0.706945523898916 0.7069442932773831 4.027194477201901e-08 -0.09990844151164607 -2.5306 0.7069455739571033 0.7069443415332005 4.0735783503331735e-08 -0.09990846931268157 -2.5307000000000004 0.7069456240051082 0.7069443897693551 4.118014654275193e-08 -0.09990849710527935 -2.5308 0.7069456740427245 0.7069444379860619 4.160493730955006e-08 -0.09990852488944199 -2.5309 0.7069457240697449 0.7069444861835368 4.201006373327765e-08 -0.09990855266517197 -2.531 0.7069457740859624 0.7069445343619964 4.2395438331829793e-08 -0.09990858043247197 -2.5311000000000003 0.706945824091168 0.7069445825216589 4.2760978204506306e-08 -0.09990860819134452 -2.5312 0.7069458740851522 0.7069446306627425 4.310660504588948e-08 -0.09990863594179211 -2.5313000000000003 0.7069459240677046 0.7069446787854664 4.3432245170130224e-08 -0.0999086636838173 -2.5314 0.7069459740386145 0.7069447268900508 4.373782951268279e-08 -0.0999086914174227 -2.5315 0.7069460239976704 0.7069447749767164 4.402329366846869e-08 -0.09990871914261089 -2.5316000000000005 0.7069460739446594 0.7069448230456847 4.4288577895346126e-08 -0.09990874685938435 -2.5317000000000003 0.7069461238793686 0.7069448710971775 4.453362711064057e-08 -0.09990877456774562 -2.5318 0.7069461738015849 0.7069449191314174 4.475839092236977e-08 -0.0999088022676973 -2.5319000000000003 0.706946223711094 0.7069449671486274 4.49628236327132e-08 -0.09990882995924191 -2.532 0.7069462736076817 0.7069450151490307 4.514688424321622e-08 -0.09990885764238203 -2.5321000000000002 0.7069463234911335 0.7069450631328513 4.5310536479076235e-08 -0.0999088853171202 -2.5322000000000005 0.706946373361234 0.7069451111003129 4.5453748778734315e-08 -0.09990891298345891 -2.5323 0.706946423217768 0.7069451590516402 4.557649429560995e-08 -0.09990894064140082 -2.5324 0.7069464730605198 0.7069452069870575 4.5678750911978816e-08 -0.09990896829094836 -2.5325 0.7069465228892737 0.7069452549067898 4.576050125805475e-08 -0.09990899593210409 -2.5326000000000004 0.7069465727038136 0.7069453028110626 4.582173269290779e-08 -0.09990902356487066 -2.5327 0.7069466225039236 0.7069453507001 4.586243730272943e-08 -0.09990905118925053 -2.5328000000000004 0.706946672289388 0.7069453985741275 4.588261192164933e-08 -0.09990907880524628 -2.5329 0.7069467220599903 0.70694544643337 4.588225811091862e-08 -0.0999091064128604 -2.533 0.7069467718155151 0.7069454942780523 4.58613821745224e-08 -0.0999091340120955 -2.5331000000000006 0.706946821555746 0.7069455421083991 4.581999514703672e-08 -0.09990916160295404 -2.5332000000000003 0.7069468712804678 0.7069455899246353 4.575811279015907e-08 -0.09990918918543865 -2.5333 0.7069469209894652 0.7069456377269849 4.567575558056536e-08 -0.09990921675955178 -2.5334 0.7069469706825231 0.7069456855156724 4.5572948727257145e-08 -0.09990924432529603 -2.5335 0.7069470203594262 0.7069457332909213 4.544972213339771e-08 -0.0999092718826739 -2.5336000000000003 0.7069470700199605 0.7069457810529549 4.5306110413659284e-08 -0.09990929943168793 -2.5337 0.7069471196639121 0.7069458288019964 4.5142152859528606e-08 -0.09990932697234071 -2.5338000000000003 0.7069471692910676 0.7069458765382683 4.49578934618583e-08 -0.09990935450463478 -2.5339 0.7069472189012135 0.7069459242619923 4.4753380862294634e-08 -0.09990938202857258 -2.534 0.7069472684941378 0.7069459719733899 4.4528668379298364e-08 -0.09990940954415671 -2.5341000000000005 0.7069473180696285 0.7069460196726818 4.428381395957248e-08 -0.09990943705138966 -2.5342000000000002 0.7069473676274749 0.706946067360088 4.401888019020528e-08 -0.09990946455027401 -2.5343 0.7069474171674661 0.7069461150358276 4.3733934255302254e-08 -0.09990949204081226 -2.5344 0.7069474666893931 0.7069461627001197 4.342904794639446e-08 -0.09990951952300696 -2.5345 0.7069475161930467 0.7069462103531816 4.310429763468293e-08 -0.09990954699686062 -2.5346 0.7069475656782194 0.7069462579952304 4.2759764238078923e-08 -0.0999095744623758 -2.5347000000000004 0.706947615144704 0.7069463056264815 4.2395533219469206e-08 -0.09990960191955503 -2.5348 0.7069476645922943 0.7069463532471503 4.2011694562429924e-08 -0.09990962936840078 -2.5349 0.7069477140207858 0.7069464008574505 4.160834274000158e-08 -0.09990965680891563 -2.535 0.7069477634299746 0.7069464484575949 4.118557670428069e-08 -0.0999096842411021 -2.5351000000000004 0.7069478128196576 0.7069464960477955 4.074349985172532e-08 -0.09990971166496271 -2.5352 0.7069478621896333 0.7069465436282624 4.028221999886894e-08 -0.09990973908049995 -2.5353000000000003 0.7069479115397014 0.7069465911992051 3.980184936150377e-08 -0.09990976648771638 -2.5354 0.7069479608696627 0.7069466387608319 3.9302504526925186e-08 -0.09990979388661453 -2.5355 0.7069480101793195 0.7069466863133491 3.8784306422706694e-08 -0.09990982127719691 -2.5356000000000005 0.7069480594684754 0.7069467338569624 3.8247380288944366e-08 -0.09990984865946607 -2.5357000000000003 0.7069481087369349 0.706946781391876 3.769185564009292e-08 -0.0999098760334245 -2.5358 0.7069481579845045 0.7069468289182921 3.711786625282265e-08 -0.0999099033990747 -2.5359000000000003 0.7069482072109924 0.7069468764364119 3.652555011571246e-08 -0.09990993075641923 -2.536 0.7069482564162077 0.706946923946435 3.591504940669843e-08 -0.0999099581054606 -2.5361000000000002 0.7069483055999612 0.7069469714485592 3.528651045144049e-08 -0.09990998544620132 -2.5362000000000005 0.7069483547620656 0.706947018942981 3.464008369209737e-08 -0.09991001277864386 -2.5363 0.7069484039023352 0.7069470664298947 3.397592364569324e-08 -0.09991004010279078 -2.5364 0.7069484530205861 0.7069471139094939 3.329418889197466e-08 -0.09991006741864467 -2.5365 0.7069485021166357 0.7069471613819694 3.259504199187857e-08 -0.09991009472620796 -2.5366000000000004 0.7069485511903038 0.7069472088475107 3.187864949100172e-08 -0.09991012202548318 -2.5367 0.7069486002414114 0.7069472563063053 3.11451818606201e-08 -0.09991014931647284 -2.5368000000000004 0.7069486492697818 0.7069473037585388 3.039481344738193e-08 -0.09991017659917942 -2.5369 0.7069486982752405 0.7069473512043949 2.9627722452491012e-08 -0.0999102038736055 -2.537 0.7069487472576141 0.7069473986440554 2.884409087619555e-08 -0.0999102311397535 -2.5371000000000006 0.706948796216732 0.7069474460777004 2.804410448829786e-08 -0.09991025839762603 -2.5372000000000003 0.7069488451524251 0.7069474935055075 2.7227952770908503e-08 -0.09991028564722552 -2.5373 0.7069488940645268 0.7069475409276523 2.639582886640457e-08 -0.09991031288855456 -2.5374 0.7069489429528724 0.7069475883443085 2.5547929553143556e-08 -0.09991034012161559 -2.5375 0.7069489918172994 0.7069476357556472 2.468445518301332e-08 -0.09991036734641116 -2.5376000000000003 0.7069490406576473 0.7069476831618379 2.3805609646737613e-08 -0.09991039456294373 -2.5377 0.7069490894737583 0.7069477305630472 2.2911600318364922e-08 -0.09991042177121587 -2.5378000000000003 0.7069491382654762 0.7069477779594402 2.2002637996287877e-08 -0.09991044897123 -2.5379 0.7069491870326479 0.706947825351179 2.1078936870283504e-08 -0.09991047616298868 -2.538 0.7069492357751219 0.7069478727384236 2.014071447814514e-08 -0.09991050334649437 -2.5381000000000005 0.7069492844927496 0.706947920121332 1.918819161981361e-08 -0.09991053052174968 -2.5382000000000002 0.7069493331853846 0.7069479675000592 1.8221592340030013e-08 -0.09991055768875702 -2.5383 0.7069493818528827 0.706948014874758 1.7241143855477314e-08 -0.09991058484751891 -2.5384 0.7069494304951027 0.7069480622455786 1.624707650967755e-08 -0.09991061199803784 -2.5385 0.7069494791119055 0.706948109612669 1.523962372875637e-08 -0.09991063914031628 -2.5386 0.7069495277031548 0.7069481569761744 1.4219021939043675e-08 -0.09991066627435681 -2.5387000000000004 0.7069495762687168 0.7069482043362374 1.318551053151179e-08 -0.09991069340016187 -2.5388 0.7069496248084602 0.7069482516929981 1.213933181667265e-08 -0.09991072051773399 -2.5389 0.7069496733222563 0.7069482990465941 1.108073094217843e-08 -0.09991074762707564 -2.539 0.7069497218099794 0.7069483463971599 1.0009955843381935e-08 -0.09991077472818932 -2.5391000000000004 0.7069497702715061 0.7069483937448275 8.927257192162252e-09 -0.09991080182107755 -2.5392 0.706949818706716 0.7069484410897267 7.832888337944155e-09 -0.09991082890574282 -2.5393000000000003 0.7069498671154912 0.7069484884319837 6.7271052469827786e-09 -0.09991085598218759 -2.5394 0.7069499154977168 0.7069485357717222 5.610166433842045e-09 -0.09991088305041435 -2.5395 0.7069499638532806 0.7069485831090636 4.482332911087683e-09 -0.09991091011042562 -2.5396000000000005 0.7069500121820733 0.7069486304441257 3.343868122500371e-09 -0.0999109371622239 -2.5397000000000003 0.7069500604839882 0.7069486777770242 2.19503788843195e-09 -0.09991096420581166 -2.5398 0.7069501087589223 0.706948725107871 1.0361103407532934e-09 -0.09991099124119142 -2.5399000000000003 0.7069501570067744 0.7069487724367758 -1.3264414566727112e-10 -0.09991101826836563 -2.54 0.7069502052274469 0.7069488197638453 -1.3109530102098366e-09 -0.09991104528733678 -2.5401000000000002 0.7069502534208449 0.7069488670891829 -2.498541569820323e-09 -0.09991107229810739 -2.5402000000000005 0.7069503015868766 0.7069489144128893 -3.6951330805931604e-09 -0.0999110993006799 -2.5403000000000002 0.706950349725453 0.7069489617350622 -4.900448808894953e-09 -0.09991112629505677 -2.5404 0.7069503978364885 0.706949009055796 -6.114208096416607e-09 -0.09991115328124056 -2.5405 0.7069504459199004 0.7069490563751829 -7.336128419153931e-09 -0.0999111802592338 -2.5406000000000004 0.7069504939756089 0.7069491036933109 -8.565925457663937e-09 -0.0999112072290389 -2.5407 0.7069505420035374 0.7069491510102655 -9.803313159514881e-09 -0.09991123419065834 -2.5408000000000004 0.7069505900036122 0.706949198326129 -1.1048003809542573e-08 -0.09991126114409461 -2.5409 0.7069506379757626 0.7069492456409807 -1.2299708094468814e-08 -0.0999112880893502 -2.541 0.7069506859199218 0.7069492929548967 -1.3558135169688262e-08 -0.09991131502642756 -2.5411000000000006 0.7069507338360252 0.70694934026795 -1.4822992733427853e-08 -0.09991134195532918 -2.5412000000000003 0.7069507817240119 0.7069493875802103 -1.6093987081824274e-08 -0.09991136887605755 -2.5413 0.7069508295838243 0.7069494348917442 -1.737082318915492e-08 -0.09991139578861515 -2.5414 0.7069508774154073 0.7069494822026156 -1.8653204770721632e-08 -0.09991142269300447 -2.5415 0.7069509252187096 0.7069495295128843 -1.9940834351372255e-08 -0.09991144958922803 -2.5416000000000003 0.706950972993683 0.7069495768226075 -2.1233413339226404e-08 -0.0999114764772882 -2.5417 0.7069510207402823 0.7069496241318389 -2.253064208552341e-08 -0.09991150335718751 -2.5418000000000003 0.7069510684584657 0.7069496714406291 -2.3832219962684892e-08 -0.0999115302289284 -2.5419 0.7069511161481946 0.7069497187490257 -2.5137845432402633e-08 -0.09991155709251341 -2.542 0.7069511638094338 0.7069497660570723 -2.644721611069073e-08 -0.09991158394794496 -2.5421000000000005 0.706951211442151 0.7069498133648103 -2.7760028844430254e-08 -0.09991161079522559 -2.5422000000000002 0.7069512590463176 0.7069498606722768 -2.9075979775554026e-08 -0.09991163763435768 -2.5423 0.706951306621908 0.7069499079795065 -3.039476441824181e-08 -0.09991166446534376 -2.5424 0.7069513541688999 0.7069499552865302 -3.171607772267139e-08 -0.09991169128818628 -2.5425 0.706951401687274 0.7069500025933756 -3.303961414592542e-08 -0.09991171810288771 -2.5426 0.706951449177015 0.7069500499000673 -3.436506772745186e-08 -0.09991174490945054 -2.5427000000000004 0.7069514966381103 0.706950097206626 -3.5692132157368744e-08 -0.09991177170787718 -2.5428 0.7069515440705512 0.7069501445130704 -3.702050084769624e-08 -0.09991179849817021 -2.5429 0.706951591474331 0.7069501918194143 -3.834986700044455e-08 -0.09991182528033199 -2.543 0.7069516388494479 0.7069502391256693 -3.967992368112284e-08 -0.09991185205436502 -2.5431000000000004 0.7069516861959022 0.7069502864318433 -4.101036388894129e-08 -0.09991187882027178 -2.5432 0.7069517335136984 0.706950333737941 -4.23408806278806e-08 -0.09991190557805472 -2.5433000000000003 0.7069517808028435 0.7069503810439637 -4.367116697757842e-08 -0.09991193232771628 -2.5434 0.7069518280633481 0.7069504283499094 -4.5000916163443405e-08 -0.09991195906925893 -2.5435 0.7069518752952264 0.706950475655773 -4.632982162798213e-08 -0.09991198580268516 -2.5436000000000005 0.7069519224984955 0.706950522961546 -4.765757710060818e-08 -0.09991201252799742 -2.5437000000000003 0.7069519696731761 0.7069505702672165 -4.898387666860994e-08 -0.09991203924519818 -2.5438 0.7069520168192918 0.7069506175727696 -5.030841484805065e-08 -0.09991206595428992 -2.5439000000000003 0.7069520639368694 0.7069506648781867 -5.16308866534013e-08 -0.09991209265527504 -2.544 0.7069521110259396 0.7069507121834462 -5.2950987670073724e-08 -0.09991211934815598 -2.5441000000000003 0.7069521580865358 0.7069507594885236 -5.426841412055697e-08 -0.09991214603293529 -2.5442000000000005 0.7069522051186949 0.7069508067933904 -5.5582862936841976e-08 -0.09991217270961542 -2.5443000000000002 0.706952252122457 0.7069508540980154 -5.689403182970211e-08 -0.09991219937819874 -2.5444 0.7069522990978656 0.7069509014023635 -5.820161935623895e-08 -0.09991222603868775 -2.5445 0.7069523460449669 0.7069509487063974 -5.9505324994909084e-08 -0.09991225269108493 -2.5446000000000004 0.7069523929638108 0.7069509960100757 -6.080484920688994e-08 -0.09991227933539269 -2.5447 0.7069524398544504 0.7069510433133545 -6.209989350915504e-08 -0.09991230597161355 -2.5448000000000004 0.7069524867169416 0.7069510906161858 -6.339016054473026e-08 -0.09991233259974984 -2.5449 0.7069525335513437 0.7069511379185192 -6.467535414687864e-08 -0.0999123592198041 -2.545 0.7069525803577196 0.7069511852203009 -6.595517940913981e-08 -0.0999123858317788 -2.5451000000000006 0.7069526271361346 0.7069512325214738 -6.722934275081582e-08 -0.09991241243567635 -2.5452000000000004 0.7069526738866578 0.7069512798219783 -6.849755199113058e-08 -0.09991243903149927 -2.5453 0.7069527206093608 0.7069513271217505 -6.975951640604203e-08 -0.0999124656192499 -2.5454 0.7069527673043184 0.7069513744207243 -7.101494680110051e-08 -0.09991249219893072 -2.5455 0.706952813971609 0.7069514217188304 -7.226355557866937e-08 -0.0999125187705442 -2.5456000000000003 0.706952860611314 0.7069514690159963 -7.350505679907388e-08 -0.0999125453340928 -2.5457 0.706952907223517 0.7069515163121461 -7.47391662504239e-08 -0.09991257188957892 -2.5458000000000003 0.7069529538083056 0.7069515636072016 -7.596560151366602e-08 -0.099912598437005 -2.5459 0.7069530003657701 0.706951610901081 -7.718408202156413e-08 -0.09991262497637357 -2.546 0.7069530468960037 0.7069516581936999 -7.839432912808836e-08 -0.09991265150768702 -2.5461000000000005 0.7069530933991024 0.7069517054849709 -7.959606617216619e-08 -0.09991267803094779 -2.5462000000000002 0.7069531398751654 0.7069517527748029 -8.07890185375304e-08 -0.0999127045461583 -2.5463 0.7069531863242946 0.706951800063103 -8.197291371993959e-08 -0.09991273105332098 -2.5464 0.706953232746595 0.7069518473497745 -8.314748138442407e-08 -0.09991275755243828 -2.5465 0.7069532791421749 0.7069518946347186 -8.431245342686855e-08 -0.09991278404351273 -2.5466 0.7069533255111446 0.7069519419178334 -8.546756404513578e-08 -0.09991281052654671 -2.5467000000000004 0.7069533718536176 0.7069519891990135 -8.661254978850619e-08 -0.09991283700154263 -2.5468 0.7069534181697106 0.7069520364781512 -8.77471496183932e-08 -0.09991286346850295 -2.5469 0.7069534644595419 0.7069520837551364 -8.887110497513007e-08 -0.09991288992743012 -2.547 0.7069535107232341 0.7069521310298559 -8.998415983001162e-08 -0.09991291637832654 -2.5471000000000004 0.7069535569609112 0.7069521783021934 -9.108606074861164e-08 -0.09991294282119467 -2.5472 0.7069536031727006 0.7069522255720305 -9.217655694629401e-08 -0.09991296925603689 -2.5473000000000003 0.7069536493587323 0.7069522728392461 -9.325540034198915e-08 -0.09991299568285575 -2.5474 0.7069536955191389 0.7069523201037162 -9.432234561804198e-08 -0.09991302210165363 -2.5475 0.7069537416540553 0.7069523673653142 -9.537715027485572e-08 -0.09991304851243293 -2.5476000000000005 0.7069537877636192 0.706952414623911 -9.641957469420925e-08 -0.09991307491519612 -2.5477000000000003 0.7069538338479708 0.706952461879375 -9.744938217742111e-08 -0.09991310130994557 -2.5478 0.7069538799072528 0.7069525091315723 -9.846633901213625e-08 -0.09991312769668376 -2.5479000000000003 0.7069539259416106 0.7069525563803661 -9.947021451656157e-08 -0.09991315407541314 -2.548 0.7069539719511917 0.7069526036256174 -1.004607811001812e-07 -0.09991318044613612 -2.5481000000000003 0.706954017936146 0.7069526508671848 -1.014378143131961e-07 -0.09991320680885513 -2.5482000000000005 0.7069540638966261 0.7069526981049244 -1.0240109289075955e-07 -0.09991323316357253 -2.5483000000000002 0.7069541098327866 0.7069527453386901 -1.0335039880675356e-07 -0.09991325951029083 -2.5484 0.7069541557447847 0.7069527925683335 -1.0428551733103475e-07 -0.09991328584901248 -2.5485 0.7069542016327796 0.7069528397937037 -1.0520623706499616e-07 -0.09991331217973978 -2.5486000000000004 0.7069542474969328 0.7069528870146479 -1.0611234999794578e-07 -0.09991333850247525 -2.5487 0.706954293337408 0.7069529342310108 -1.07003651551342e-07 -0.09991336481722127 -2.5488000000000004 0.7069543391543711 0.7069529814426354 -1.0787994062216172e-07 -0.09991339112398033 -2.5489 0.7069543849479903 0.7069530286493622 -1.0874101962973781e-07 -0.0999134174227548 -2.549 0.7069544307184354 0.7069530758510292 -1.0958669457647452e-07 -0.09991344371354707 -2.5491 0.7069544764658785 0.7069531230474735 -1.1041677505999048e-07 -0.0999134699963596 -2.5492000000000004 0.7069545221904937 0.7069531702385292 -1.1123107433036461e-07 -0.0999134962711948 -2.5493 0.7069545678924573 0.7069532174240293 -1.1202940934824934e-07 -0.09991352253805515 -2.5494 0.7069546135719472 0.7069532646038037 -1.1281160080395258e-07 -0.09991354879694302 -2.5495 0.7069546592291434 0.7069533117776816 -1.1357747317294886e-07 -0.09991357504786082 -2.5496000000000003 0.7069547048642271 0.7069533589454895 -1.1432685474190019e-07 -0.09991360129081095 -2.5497 0.7069547504773821 0.7069534061070526 -1.1505957765202413e-07 -0.09991362752579587 -2.5498000000000003 0.7069547960687935 0.7069534532621943 -1.1577547793552301e-07 -0.09991365375281792 -2.5499 0.7069548416386484 0.7069535004107361 -1.164743955658909e-07 -0.09991367997187961 -2.55 0.7069548871871352 0.706953547552498 -1.1715617447352611e-07 -0.09991370618298329 -2.5501000000000005 0.7069549327144444 0.7069535946872982 -1.1782066259603818e-07 -0.09991373238613137 -2.5502000000000002 0.7069549782207678 0.7069536418149536 -1.184677118938604e-07 -0.09991375858132633 -2.5503 0.7069550237062987 0.7069536889352792 -1.1909717840749567e-07 -0.09991378476857055 -2.5504000000000002 0.706955069171232 0.7069537360480886 -1.1970892226965957e-07 -0.09991381094786639 -2.5505 0.7069551146157638 0.7069537831531942 -1.2030280774517899e-07 -0.0999138371192163 -2.5506 0.7069551600400918 0.7069538302504066 -1.2087870326048245e-07 -0.09991386328262265 -2.5507000000000004 0.7069552054444155 0.7069538773395355 -1.2143648142268204e-07 -0.09991388943808793 -2.5508 0.7069552508289351 0.7069539244203892 -1.2197601906988043e-07 -0.09991391558561455 -2.5509 0.7069552961938523 0.706953971492774 -1.2249719727984443e-07 -0.09991394172520489 -2.551 0.7069553415393697 0.7069540185564958 -1.2299990140123007e-07 -0.09991396785686127 -2.5511000000000004 0.7069553868656915 0.7069540656113592 -1.2348402107439926e-07 -0.0999139939805862 -2.5512 0.7069554321730231 0.7069541126571673 -1.2394945025744064e-07 -0.09991402009638206 -2.5513000000000003 0.7069554774615705 0.7069541596937226 -1.243960872660682e-07 -0.09991404620425125 -2.5514 0.7069555227315412 0.7069542067208259 -1.2482383477882553e-07 -0.09991407230419617 -2.5515 0.7069555679831434 0.7069542537382779 -1.252325998457593e-07 -0.09991409839621923 -2.5516000000000005 0.7069556132165863 0.7069543007458776 -1.2562229393005275e-07 -0.09991412448032286 -2.5517000000000003 0.7069556584320799 0.7069543477434234 -1.2599283293231178e-07 -0.09991415055650937 -2.5518 0.7069557036298355 0.7069543947307124 -1.2634413717842186e-07 -0.0999141766247812 -2.5519000000000003 0.7069557488100644 0.706954441707542 -1.2667613147332446e-07 -0.09991420268514078 -2.552 0.7069557939729798 0.7069544886737077 -1.2698874508540459e-07 -0.0999142287375905 -2.5521000000000003 0.7069558391187947 0.7069545356290051 -1.272819117881241e-07 -0.09991425478213281 -2.5522000000000005 0.7069558842477226 0.7069545825732286 -1.2755556983920502e-07 -0.09991428081877 -2.5523000000000002 0.7069559293599785 0.7069546295061722 -1.2780966204307964e-07 -0.09991430684750457 -2.5524 0.7069559744557771 0.7069546764276293 -1.2804413571272655e-07 -0.09991433286833887 -2.5525 0.7069560195353339 0.7069547233373927 -1.282589427043651e-07 -0.09991435888127524 -2.5526000000000004 0.7069560645988653 0.7069547702352552 -1.2845403943653744e-07 -0.09991438488631617 -2.5527 0.7069561096465877 0.7069548171210087 -1.2862938688490422e-07 -0.09991441088346403 -2.5528000000000004 0.7069561546787175 0.7069548639944447 -1.2878495058397943e-07 -0.09991443687272117 -2.5529 0.7069561996954721 0.7069549108553546 -1.2892070064447758e-07 -0.09991446285409 -2.553 0.7069562446970687 0.7069549577035297 -1.2903661176545678e-07 -0.09991448882757295 -2.5531 0.7069562896837249 0.7069550045387607 -1.2913266321523675e-07 -0.09991451479317237 -2.5532000000000004 0.7069563346556587 0.7069550513608385 -1.2920883886609336e-07 -0.09991454075089067 -2.5533 0.7069563796130877 0.7069550981695536 -1.2926512716476823e-07 -0.09991456670073023 -2.5534 0.7069564245562296 0.7069551449646965 -1.2930152116022442e-07 -0.09991459264269341 -2.5535 0.7069564694853029 0.7069551917460577 -1.293180184793602e-07 -0.09991461857678269 -2.5536000000000003 0.7069565144005253 0.7069552385134279 -1.2931462135129523e-07 -0.09991464450300042 -2.5537 0.7069565593021143 0.7069552852665975 -1.2929133659002334e-07 -0.0999146704213489 -2.5538000000000003 0.7069566041902879 0.7069553320053574 -1.2924817559441248e-07 -0.09991469633183063 -2.5539 0.7069566490652637 0.7069553787294987 -1.2918515434473532e-07 -0.09991472223444792 -2.554 0.7069566939272587 0.7069554254388122 -1.2910229339573032e-07 -0.09991474812920322 -2.5541000000000005 0.70695673877649 0.7069554721330895 -1.2899961787139758e-07 -0.09991477401609888 -2.5542000000000002 0.7069567836131744 0.7069555188121225 -1.2887715747193773e-07 -0.09991479989513728 -2.5543 0.706956828437528 0.7069555654757029 -1.2873494642864913e-07 -0.09991482576632078 -2.5544000000000002 0.7069568732497669 0.7069556121236236 -1.285730235299487e-07 -0.0999148516296518 -2.5545 0.7069569180501064 0.7069556587556778 -1.2839143210749415e-07 -0.09991487748513278 -2.5546 0.7069569628387613 0.7069557053716589 -1.281902200084284e-07 -0.09991490333276598 -2.5547000000000004 0.7069570076159459 0.7069557519713605 -1.2796943958844065e-07 -0.09991492917255382 -2.5548 0.7069570523818741 0.706955798554578 -1.2772914770309285e-07 -0.09991495500449869 -2.5549 0.7069570971367587 0.7069558451211062 -1.2746940569394183e-07 -0.09991498082860294 -2.555 0.706957141880812 0.7069558916707419 -1.271902793711921e-07 -0.09991500664486902 -2.5551000000000004 0.7069571866142458 0.7069559382032816 -1.2689183899461387e-07 -0.09991503245329926 -2.5552 0.7069572313372707 0.706955984718523 -1.2657415925793059e-07 -0.09991505825389606 -2.5553000000000003 0.7069572760500963 0.7069560312162646 -1.2623731927494108e-07 -0.09991508404666172 -2.5554 0.7069573207529318 0.7069560776963059 -1.2588140254135571e-07 -0.0999151098315987 -2.5555 0.7069573654459853 0.7069561241584474 -1.255064969400005e-07 -0.09991513560870936 -2.5556000000000005 0.7069574101294636 0.7069561706024903 -1.2511269470265318e-07 -0.09991516137799605 -2.5557000000000003 0.7069574548035726 0.7069562170282371 -1.2470009239269608e-07 -0.09991518713946113 -2.5558 0.7069574994685174 0.7069562634354913 -1.2426879088082987e-07 -0.09991521289310701 -2.5559000000000003 0.7069575441245016 0.7069563098240578 -1.2381889532599166e-07 -0.09991523863893603 -2.556 0.706957588771728 0.7069563561937422 -1.2335051512851747e-07 -0.09991526437695061 -2.5561000000000003 0.7069576334103975 0.7069564025443514 -1.228637639370811e-07 -0.09991529010715304 -2.5562000000000005 0.7069576780407104 0.7069564488756939 -1.2235875959665243e-07 -0.09991531582954573 -2.5563000000000002 0.7069577226628654 0.7069564951875794 -1.2183562412768079e-07 -0.09991534154413104 -2.5564 0.70695776727706 0.7069565414798192 -1.212944836844615e-07 -0.09991536725091144 -2.5565 0.70695781188349 0.7069565877522254 -1.207354685516665e-07 -0.09991539294988917 -2.5566000000000004 0.7069578564823501 0.7069566340046115 -1.2015871309577209e-07 -0.09991541864106662 -2.5567 0.7069579010738332 0.7069566802367935 -1.1956435573209911e-07 -0.09991544432444618 -2.5568 0.7069579456581305 0.7069567264485874 -1.1895253888664914e-07 -0.09991547000003015 -2.5569 0.7069579902354322 0.7069567726398129 -1.1832340898049187e-07 -0.09991549566782101 -2.557 0.7069580348059266 0.7069568188102893 -1.1767711637772349e-07 -0.09991552132782104 -2.5571 0.7069580793698 0.7069568649598386 -1.1701381535771105e-07 -0.09991554698003263 -2.5572000000000004 0.7069581239272378 0.7069569110882838 -1.1633366407345913e-07 -0.09991557262445812 -2.5573 0.7069581684784227 0.7069569571954508 -1.1563682452732371e-07 -0.0999155982610999 -2.5574 0.7069582130235363 0.7069570032811661 -1.1492346250509267e-07 -0.09991562388996028 -2.5575 0.706958257562758 0.7069570493452586 -1.1419374756557743e-07 -0.09991564951104168 -2.5576000000000003 0.7069583020962654 0.7069570953875595 -1.1344785299030602e-07 -0.09991567512434646 -2.5577 0.7069583466242346 0.7069571414079006 -1.126859557297466e-07 -0.09991570072987693 -2.5578000000000003 0.7069583911468392 0.706957187406117 -1.1190823637555192e-07 -0.09991572632763551 -2.5579 0.7069584356642511 0.7069572333820451 -1.1111487912239537e-07 -0.09991575191762453 -2.558 0.70695848017664 0.706957279335523 -1.1030607170899043e-07 -0.09991577749984631 -2.5581000000000005 0.7069585246841736 0.7069573252663919 -1.0948200538166142e-07 -0.09991580307430324 -2.5582000000000003 0.7069585691870177 0.7069573711744941 -1.0864287484577129e-07 -0.09991582864099766 -2.5583 0.7069586136853354 0.7069574170596744 -1.0778887822148614e-07 -0.09991585419993192 -2.5584000000000002 0.7069586581792888 0.7069574629217801 -1.0692021701168286e-07 -0.09991587975110838 -2.5585 0.7069587026690363 0.7069575087606601 -1.0603709603256017e-07 -0.09991590529452939 -2.5586 0.7069587471547352 0.7069575545761659 -1.0513972336680111e-07 -0.0999159308301973 -2.5587000000000004 0.7069587916365397 0.7069576003681513 -1.0422831032974589e-07 -0.09991595635811448 -2.5588 0.7069588361146026 0.7069576461364722 -1.0330307140607453e-07 -0.09991598187828327 -2.5589 0.7069588805890739 0.7069576918809872 -1.023642242055714e-07 -0.09991600739070605 -2.559 0.7069589250601007 0.7069577376015569 -1.0141198941888974e-07 -0.09991603289538514 -2.5591000000000004 0.7069589695278284 0.7069577832980445 -1.004465907516322e-07 -0.09991605839232286 -2.5592 0.7069590139923996 0.7069578289703151 -9.946825487317651e-08 -0.09991608388152157 -2.5593000000000004 0.7069590584539548 0.7069578746182374 -9.847721137243998e-08 -0.09991610936298366 -2.5594 0.7069591029126316 0.7069579202416818 -9.74736927067052e-08 -0.09991613483671145 -2.5595 0.7069591473685655 0.706957965840521 -9.645793413309844e-08 -0.09991616030270728 -2.5596000000000005 0.7069591918218885 0.706958011414631 -9.543017366522161e-08 -0.09991618576097348 -2.5597000000000003 0.7069592362727313 0.70695805696389 -9.439065200376323e-08 -0.09991621121151242 -2.5598 0.706959280721221 0.7069581024881787 -9.333961249920197e-08 -0.09991623665432645 -2.5599000000000003 0.7069593251674828 0.7069581479873808 -9.227730107981558e-08 -0.0999162620894179 -2.56 0.7069593696116385 0.706958193461382 -9.120396620918014e-08 -0.09991628751678913 -2.5601000000000003 0.7069594140538077 0.7069582389100715 -9.011985880116868e-08 -0.09991631293644243 -2.5602000000000005 0.7069594584941068 0.7069582843333408 -8.902523219393027e-08 -0.09991633834838017 -2.5603000000000002 0.7069595029326499 0.7069583297310845 -8.792034206488858e-08 -0.0999163637526047 -2.5604 0.7069595473695484 0.7069583751031996 -8.680544638910853e-08 -0.09991638914911839 -2.5605 0.7069595918049103 0.7069584204495858 -8.568080537077472e-08 -0.0999164145379235 -2.5606000000000004 0.7069596362388415 0.7069584657701458 -8.454668137640453e-08 -0.09991643991902244 -2.5607 0.7069596806714444 0.7069585110647854 -8.340333888193913e-08 -0.0999164652924175 -2.5608 0.7069597251028192 0.7069585563334129 -8.225104441723224e-08 -0.09991649065811108 -2.5609 0.7069597695330627 0.7069586015759394 -8.109006648972239e-08 -0.09991651601610542 -2.561 0.7069598139622686 0.7069586467922794 -7.992067552718696e-08 -0.09991654136640288 -2.5611 0.7069598583905286 0.7069586919823501 -7.874314382223108e-08 -0.09991656670900587 -2.5612000000000004 0.7069599028179303 0.7069587371460713 -7.755774545682714e-08 -0.09991659204391663 -2.5613 0.7069599472445591 0.7069587822833665 -7.636475625460992e-08 -0.09991661737113756 -2.5614 0.7069599916704974 0.7069588273941613 -7.516445369153829e-08 -0.09991664269067095 -2.5615 0.7069600360958241 0.7069588724783848 -7.395711685903236e-08 -0.09991666800251914 -2.5616000000000003 0.7069600805206158 0.7069589175359694 -7.274302637810467e-08 -0.0999166933066845 -2.5617 0.7069601249449455 0.70695896256685 -7.152246434861953e-08 -0.09991671860316935 -2.5618000000000003 0.7069601693688831 0.7069590075709647 -7.029571427079676e-08 -0.09991674389197598 -2.5619 0.7069602137924955 0.7069590525482545 -6.906306099663945e-08 -0.0999167691731067 -2.562 0.7069602582158472 0.7069590974986639 -6.782479064449884e-08 -0.09991679444656387 -2.5621000000000005 0.7069603026389986 0.7069591424221402 -6.658119054573156e-08 -0.09991681971234981 -2.5622000000000003 0.7069603470620078 0.7069591873186338 -6.533254917314227e-08 -0.09991684497046688 -2.5623 0.7069603914849294 0.7069592321880985 -6.40791560750642e-08 -0.0999168702209174 -2.5624000000000002 0.7069604359078151 0.7069592770304909 -6.282130180857229e-08 -0.09991689546370369 -2.5625 0.7069604803307128 0.7069593218457706 -6.155927787139526e-08 -0.09991692069882807 -2.5626 0.7069605247536681 0.7069593666339005 -6.029337663252671e-08 -0.09991694592629277 -2.5627000000000004 0.7069605691767232 0.706959411394847 -5.90238912710761e-08 -0.09991697114610025 -2.5628 0.706960613599917 0.7069594561285795 -5.7751115701892494e-08 -0.09991699635825281 -2.5629 0.7069606580232852 0.70695950083507 -5.6475344509211364e-08 -0.09991702156275274 -2.563 0.7069607024468605 0.7069595455142942 -5.5196872879217235e-08 -0.09991704675960233 -2.5631000000000004 0.706960746870672 0.706959590166231 -5.391599653412418e-08 -0.09991707194880393 -2.5632 0.7069607912947466 0.7069596347908625 -5.263301165693221e-08 -0.09991709713035993 -2.5633000000000004 0.7069608357191071 0.7069596793881735 -5.134821483027824e-08 -0.09991712230427256 -2.5634 0.706960880143773 0.7069597239581527 -5.0061902964336664e-08 -0.09991714747054414 -2.5635 0.7069609245687613 0.7069597685007911 -4.877437322862305e-08 -0.09991717262917704 -2.5636000000000005 0.7069609689940854 0.7069598130160839 -4.7485922982713584e-08 -0.09991719778017352 -2.5637000000000003 0.7069610134197557 0.7069598575040287 -4.619684970989194e-08 -0.09991722292353594 -2.5638 0.7069610578457792 0.7069599019646268 -4.490745094537507e-08 -0.09991724805926658 -2.5639000000000003 0.7069611022721599 0.7069599463978824 -4.361802421174897e-08 -0.09991727318736779 -2.564 0.7069611466988983 0.7069599908038029 -4.2328866945656274e-08 -0.09991729830784182 -2.5641000000000003 0.7069611911259921 0.706960035182399 -4.1040276432141067e-08 -0.09991732342069104 -2.5642000000000005 0.7069612355534356 0.7069600795336848 -3.975254973624925e-08 -0.09991734852591777 -2.5643000000000002 0.7069612799812196 0.7069601238576774 -3.846598363270448e-08 -0.0999173736235243 -2.5644 0.7069613244093327 0.7069601681543966 -3.718087453804392e-08 -0.09991739871351295 -2.5645 0.7069613688377588 0.7069602124238661 -3.589751844553218e-08 -0.09991742379588597 -2.5646000000000004 0.7069614132664801 0.7069602566661123 -3.461621085078508e-08 -0.09991744887064576 -2.5647 0.706961457695475 0.7069603008811653 -3.333724669235538e-08 -0.0999174739377946 -2.5648 0.7069615021247185 0.7069603450690577 -3.206092027258599e-08 -0.09991749899733478 -2.5649 0.706961546554183 0.7069603892298257 -3.0787525200689364e-08 -0.09991752404926864 -2.565 0.706961590983837 0.7069604333635086 -2.951735432053966e-08 -0.09991754909359844 -2.5651 0.7069616354136466 0.7069604774701486 -2.8250699642693236e-08 -0.09991757413032652 -2.5652000000000004 0.7069616798435745 0.7069605215497912 -2.6987852276951288e-08 -0.09991759915945517 -2.5653 0.7069617242735804 0.7069605656024849 -2.5729102367741397e-08 -0.09991762418098671 -2.5654 0.7069617687036207 0.7069606096282816 -2.4474739027113834e-08 -0.09991764919492345 -2.5655 0.7069618131336486 0.7069606536272358 -2.322505026708735e-08 -0.09991767420126768 -2.5656000000000003 0.7069618575636145 0.7069606975994055 -2.1980322935898078e-08 -0.09991769920002168 -2.5657 0.7069619019934656 0.7069607415448516 -2.074084264665904e-08 -0.09991772419118777 -2.5658000000000003 0.706961946423146 0.7069607854636379 -1.9506893718379548e-08 -0.09991774917476821 -2.5659 0.7069619908525973 0.7069608293558316 -1.8278759106576253e-08 -0.09991777415076541 -2.566 0.706962035281757 0.7069608732215027 -1.7056720341256798e-08 -0.09991779911918158 -2.5661000000000005 0.7069620797105607 0.7069609170607241 -1.5841057461433994e-08 -0.09991782408001904 -2.5662000000000003 0.7069621241389403 0.7069609608735719 -1.4632048948338972e-08 -0.0999178490332801 -2.5663 0.7069621685668248 0.7069610046601249 -1.342997166557322e-08 -0.09991787397896704 -2.5664000000000002 0.7069622129941407 0.7069610484204655 -1.2235100791888054e-08 -0.09991789891708218 -2.5665 0.7069622574208112 0.7069610921546781 -1.1047709763505054e-08 -0.09991792384762777 -2.5666 0.7069623018467567 0.7069611358628507 -9.868070206461854e-09 -0.09991794877060621 -2.5667000000000004 0.7069623462718945 0.7069611795450739 -8.696451878932587e-09 -0.0999179736860197 -2.5668 0.7069623906961391 0.7069612232014414 -7.533122604007347e-09 -0.09991799859387057 -2.5669 0.7069624351194022 0.7069612668320494 -6.3783482124463164e-09 -0.09991802349416107 -2.567 0.706962479541593 0.7069613104369971 -5.232392479362358e-09 -0.09991804838689354 -2.5671000000000004 0.7069625239626174 0.7069613540163864 -4.0955170704445876e-09 -0.09991807327207024 -2.5672 0.7069625683823786 0.7069613975703226 -2.9679814786409686e-09 -0.09991809814969349 -2.5673000000000004 0.7069626128007772 0.7069614410989127 -1.8500429539020091e-09 -0.09991812301976553 -2.5674 0.706962657217711 0.7069614846022676 -7.419564641494847e-10 -0.09991814788228873 -2.5675 0.7069627016330754 0.7069615280805 3.5602537758194774e-10 -0.09991817273726536 -2.5676000000000005 0.7069627460467625 0.7069615715337255 1.4436523599822837e-09 -0.0999181975846977 -2.5677000000000003 0.706962790458662 0.7069616149620624 2.5206767411203868e-09 -0.09991822242458798 -2.5678 0.7069628348686612 0.706961658365632 3.586853303087778e-09 -0.09991824725693857 -2.5679000000000003 0.7069628792766444 0.7069617017445575 4.641939393632e-09 -0.0999182720817517 -2.568 0.7069629236824936 0.7069617450989654 5.685695005086533e-09 -0.09991829689902967 -2.5681000000000003 0.7069629680860884 0.7069617884289843 6.717882805595821e-09 -0.09991832170877481 -2.5682000000000005 0.7069630124873054 0.7069618317347452 7.738268206769483e-09 -0.09991834651098935 -2.5683000000000002 0.7069630568860192 0.706961875016382 8.746619417458745e-09 -0.09991837130567557 -2.5684 0.7069631012821015 0.7069619182740308 9.742707487124525e-09 -0.09991839609283577 -2.5685 0.706963145675422 0.70696196150783 1.0726306366552751e-08 -0.09991842087247223 -2.5686000000000004 0.7069631900658478 0.7069620047179205 1.1697192954691904e-08 -0.09991844564458723 -2.5687 0.7069632344532437 0.7069620479044463 1.2655147148959989e-08 -0.0999184704091831 -2.5688 0.706963278837472 0.7069620910675521 1.3599951904225138e-08 -0.09991849516626204 -2.5689 0.7069633232183927 0.7069621342073864 1.4531393264030634e-08 -0.09991851991582634 -2.569 0.7069633675958642 0.7069621773240993 1.5449260425647038e-08 -0.09991854465787833 -2.5691 0.7069634119697419 0.7069622204178432 1.6353345779103468e-08 -0.09991856939242033 -2.5692000000000004 0.706963456339879 0.7069622634887729 1.7243444954892495e-08 -0.09991859411945453 -2.5693 0.7069635007061272 0.7069623065370446 1.8119356878613935e-08 -0.09991861883898322 -2.5694 0.7069635450683354 0.7069623495628177 1.8980883797863057e-08 -0.09991864355100868 -2.5695 0.7069635894263506 0.7069623925662528 1.982783135161953e-08 -0.09991866825553318 -2.5696000000000003 0.706963633780018 0.7069624355475131 2.0660008586727285e-08 -0.09991869295255902 -2.5697 0.7069636781291808 0.7069624785067637 2.1477228022079298e-08 -0.09991871764208848 -2.5698000000000003 0.70696372247368 0.7069625214441715 2.227930569025094e-08 -0.09991874232412379 -2.5699 0.7069637668133546 0.7069625643599051 2.306606116178611e-08 -0.09991876699866727 -2.57 0.7069638111480419 0.7069626072541355 2.383731759723895e-08 -0.09991879166572112 -2.5701000000000005 0.7069638554775772 0.7069626501270354 2.4592901793143995e-08 -0.09991881632528771 -2.5702000000000003 0.7069638998017946 0.7069626929787796 2.5332644202832877e-08 -0.09991884097736929 -2.5703 0.7069639441205252 0.7069627358095436 2.605637900061908e-08 -0.09991886562196806 -2.5704000000000002 0.7069639884335994 0.7069627786195056 2.6763944087002112e-08 -0.0999188902590863 -2.5705 0.7069640327408456 0.7069628214088456 2.7455181154587005e-08 -0.09991891488872635 -2.5706 0.7069640770420906 0.7069628641777448 2.8129935698492647e-08 -0.0999189395108905 -2.5707000000000004 0.7069641213371594 0.7069629069263859 2.8788057070128215e-08 -0.0999189641255809 -2.5708 0.7069641656258752 0.7069629496549537 2.9429398510152915e-08 -0.09991898873279989 -2.5709 0.7069642099080602 0.7069629923636336 3.005381715888433e-08 -0.09991901333254966 -2.571 0.7069642541835351 0.7069630350526137 3.06611741135443e-08 -0.09991903792483255 -2.5711000000000004 0.7069642984521189 0.7069630777220829 3.125133444213668e-08 -0.09991906250965087 -2.5712 0.7069643427136294 0.7069631203722313 3.182416722334602e-08 -0.09991908708700677 -2.5713000000000004 0.7069643869678824 0.7069631630032507 3.237954557949729e-08 -0.09991911165690254 -2.5714 0.7069644312146934 0.7069632056153341 3.291734668696422e-08 -0.09991913621934051 -2.5715 0.7069644754538759 0.706963248208676 3.3437451823006836e-08 -0.09991916077432288 -2.5716000000000006 0.7069645196852427 0.7069632907834715 3.393974637097563e-08 -0.09991918532185197 -2.5717000000000003 0.7069645639086048 0.7069633333399178 3.4424119867149106e-08 -0.09991920986193002 -2.5718 0.7069646081237726 0.7069633758782123 3.489046601808099e-08 -0.0999192343945593 -2.5719000000000003 0.7069646523305548 0.706963418398554 3.533868270927387e-08 -0.09991925891974199 -2.572 0.7069646965287599 0.7069634609011426 3.5768672046812555e-08 -0.09991928343748038 -2.5721000000000003 0.7069647407181947 0.7069635033861795 3.6180340369507125e-08 -0.09991930794777676 -2.5722000000000005 0.7069647848986655 0.7069635458538661 3.6573598273179075e-08 -0.09991933245063339 -2.5723000000000003 0.7069648290699773 0.7069635883044056 3.6948360621069654e-08 -0.09991935694605251 -2.5724 0.7069648732319344 0.7069636307380016 3.730454657159543e-08 -0.09991938143403636 -2.5725 0.7069649173843404 0.7069636731548583 3.764207959916499e-08 -0.0999194059145872 -2.5726000000000004 0.706964961526998 0.7069637155551813 3.7960887487240025e-08 -0.09991943038770734 -2.5727 0.7069650056597094 0.7069637579391763 3.8260902378642325e-08 -0.099919454853399 -2.5728 0.7069650497822757 0.7069638003070502 3.854206076688016e-08 -0.0999194793116644 -2.5729 0.7069650938944976 0.7069638426590099 3.880430350482189e-08 -0.09991950376250582 -2.573 0.7069651379961754 0.7069638849952635 3.904757584112517e-08 -0.09991952820592548 -2.5731 0.7069651820871086 0.7069639273160193 3.9271827408093873e-08 -0.09991955264192569 -2.5732000000000004 0.7069652261670964 0.7069639696214862 3.9477012230351716e-08 -0.09991957707050869 -2.5733 0.7069652702359374 0.7069640119118732 3.966308877167979e-08 -0.09991960149167667 -2.5734 0.7069653142934296 0.7069640541873904 3.983001989685264e-08 -0.09991962590543191 -2.5735 0.7069653583393714 0.7069640964482475 3.997777289592441e-08 -0.09991965031177664 -2.5736000000000003 0.7069654023735603 0.7069641386946551 4.0106319508514954e-08 -0.09991967471071322 -2.5737 0.7069654463957935 0.7069641809268237 4.021563589085009e-08 -0.09991969910224377 -2.5738000000000003 0.7069654904058682 0.7069642231449639 4.030570266259914e-08 -0.09991972348637056 -2.5739 0.7069655344035817 0.7069642653492866 4.0376504887792986e-08 -0.09991974786309582 -2.574 0.7069655783887305 0.7069643075400032 4.042803206615042e-08 -0.09991977223242188 -2.5741000000000005 0.7069656223611119 0.7069643497173244 4.046027814869069e-08 -0.09991979659435095 -2.5742000000000003 0.7069656663205227 0.7069643918814617 4.047324154640708e-08 -0.09991982094888525 -2.5743 0.7069657102667595 0.7069644340326254 4.046692511465444e-08 -0.099919845296027 -2.5744000000000002 0.7069657541996195 0.7069644761710273 4.0441336153149154e-08 -0.09991986963577852 -2.5745 0.7069657981188995 0.7069645182968778 4.039648640249971e-08 -0.09991989396814195 -2.5746 0.7069658420243969 0.7069645604103874 4.0332392042471965e-08 -0.09991991829311958 -2.5747000000000004 0.7069658859159096 0.7069646025117667 4.024907369372388e-08 -0.09991994261071364 -2.5748 0.7069659297932349 0.7069646446012261 4.0146556402193e-08 -0.09991996692092642 -2.5749 0.7069659736561712 0.7069646866789749 4.002486963389229e-08 -0.0999199912237601 -2.575 0.7069660175045169 0.7069647287452229 3.988404726970596e-08 -0.09992001551921692 -2.5751000000000004 0.7069660613380707 0.7069647708001792 3.972412758457278e-08 -0.09992003980729916 -2.5752 0.7069661051566323 0.706964812844052 3.9545153266568045e-08 -0.09992006408800902 -2.5753000000000004 0.7069661489600012 0.7069648548770495 3.934717136486188e-08 -0.09992008836134875 -2.5754 0.7069661927479782 0.7069648968993792 3.913023331053589e-08 -0.09992011262732056 -2.5755 0.7069662365203643 0.706964938911248 3.889439489229707e-08 -0.09992013688592673 -2.5756000000000006 0.7069662802769611 0.706964980912862 3.8639716237395816e-08 -0.09992016113716949 -2.5757000000000003 0.7069663240175708 0.7069650229044269 3.836626180295233e-08 -0.09992018538105102 -2.5758 0.7069663677419966 0.7069650648861472 3.8074100353405194e-08 -0.09992020961757359 -2.5759000000000003 0.7069664114500426 0.7069651068582272 3.776330496571556e-08 -0.09992023384673945 -2.576 0.7069664551415135 0.7069651488208699 3.743395296344765e-08 -0.09992025806855082 -2.5761000000000003 0.7069664988162148 0.7069651907742773 3.7086125947993764e-08 -0.09992028228300986 -2.5762000000000005 0.7069665424739533 0.7069652327186512 3.671990974826733e-08 -0.09992030649011892 -2.5763000000000003 0.7069665861145364 0.7069652746541917 3.6335394417233435e-08 -0.09992033068988017 -2.5764 0.7069666297377729 0.7069653165810981 3.593267419547963e-08 -0.09992035488229585 -2.5765 0.7069666733434719 0.7069653584995685 3.551184749560343e-08 -0.09992037906736814 -2.5766000000000004 0.7069667169314446 0.7069654004098005 3.507301687792619e-08 -0.09992040324509933 -2.5767 0.7069667605015026 0.7069654423119895 3.4616289024472224e-08 -0.0999204274154916 -2.5768 0.7069668040534596 0.7069654842063309 3.414177471294799e-08 -0.09992045157854723 -2.5769 0.706966847587129 0.7069655260930179 3.364958879072122e-08 -0.0999204757342684 -2.577 0.706966891102327 0.7069655679722427 3.313985014533061e-08 -0.09992049988265736 -2.5771 0.7069669345988703 0.7069656098441963 3.261268167326081e-08 -0.09992052402371629 -2.5772000000000004 0.7069669780765772 0.7069656517090686 3.206821026432993e-08 -0.09992054815744744 -2.5773 0.7069670215352676 0.7069656935670474 3.1506566761790866e-08 -0.09992057228385308 -2.5774 0.7069670649747624 0.7069657354183196 3.0927885917228504e-08 -0.09992059640293537 -2.5775 0.7069671083948843 0.7069657772630703 3.033230638709028e-08 -0.09992062051469652 -2.5776000000000003 0.7069671517954573 0.706965819101483 2.971997066503196e-08 -0.09992064461913874 -2.5777 0.7069671951763079 0.7069658609337403 2.909102508018291e-08 -0.09992066871626439 -2.5778000000000003 0.706967238537263 0.7069659027600224 2.8445619748573847e-08 -0.09992069280607559 -2.5779 0.7069672818781514 0.7069659445805079 2.7783908534972923e-08 -0.09992071688857451 -2.578 0.706967325198804 0.7069659863953741 2.710604901992597e-08 -0.0999207409637634 -2.5781000000000005 0.7069673684990536 0.706966028204796 2.6412202458123146e-08 -0.0999207650316445 -2.5782000000000003 0.7069674117787341 0.7069660700089478 2.5702533747173906e-08 -0.09992078909222 -2.5783 0.7069674550376819 0.7069661118080011 2.49772113755653e-08 -0.09992081314549217 -2.5784000000000002 0.7069674982757345 0.7069661536021254 2.4236407403580018e-08 -0.09992083719146318 -2.5785 0.7069675414927319 0.7069661953914892 2.348029740605051e-08 -0.09992086123013523 -2.5786000000000002 0.7069675846885157 0.7069662371762584 2.270906043246035e-08 -0.09992088526151054 -2.5787000000000004 0.70696762786293 0.7069662789565971 2.1922878970515036e-08 -0.09992090928559136 -2.5788 0.7069676710158201 0.7069663207326679 2.1121938897569748e-08 -0.09992093330237993 -2.5789 0.7069677141470339 0.7069663625046303 2.0306429442465412e-08 -0.09992095731187838 -2.579 0.706967757256421 0.7069664042726423 1.9476543134354374e-08 -0.09992098131408891 -2.5791000000000004 0.7069678003438338 0.70696644603686 1.8632475760199663e-08 -0.09992100530901381 -2.5792 0.706967843409126 0.7069664877974373 1.777442632053955e-08 -0.09992102929665526 -2.5793000000000004 0.706967886452154 0.7069665295545257 1.690259698265001e-08 -0.0999210532770155 -2.5794 0.7069679294727762 0.7069665713082743 1.601719302416621e-08 -0.09992107725009665 -2.5795 0.7069679724708533 0.7069666130588304 1.5118422803592213e-08 -0.09992110121590099 -2.5796000000000006 0.7069680154462481 0.7069666548063389 1.4206497687442587e-08 -0.0999211251744307 -2.5797000000000003 0.7069680583988263 0.7069666965509425 1.328163201554794e-08 -0.09992114912568806 -2.5798 0.706968101328455 0.7069667382927811 1.234404305421738e-08 -0.09992117306967516 -2.5799000000000003 0.7069681442350043 0.7069667800319925 1.1393950932921115e-08 -0.09992119700639425 -2.58 0.7069681871183466 0.7069668217687124 1.0431578599187641e-08 -0.09992122093584754 -2.5801000000000003 0.7069682299783568 0.7069668635030735 9.457151767429395e-09 -0.09992124485803722 -2.5802000000000005 0.7069682728149123 0.7069669052352066 8.470898866901055e-09 -0.09992126877296552 -2.5803000000000003 0.7069683156278924 0.7069669469652398 7.47305097664741e-09 -0.09992129268063465 -2.5804 0.7069683584171795 0.7069669886932983 6.463841787339442e-09 -0.09992131658104675 -2.5805 0.7069684011826587 0.7069670304195054 5.443507538824277e-09 -0.09992134047420409 -2.5806000000000004 0.7069684439242172 0.7069670721439812 4.4122869654814045e-09 -0.09992136436010884 -2.5807 0.7069684866417449 0.7069671138668439 3.3704212415788803e-09 -0.0999213882387632 -2.5808 0.7069685293351344 0.7069671555882084 2.3181539196906464e-09 -0.09992141211016939 -2.5809 0.7069685720042809 0.7069671973081877 1.2557308777874643e-09 -0.09992143597432959 -2.581 0.7069686146490821 0.7069672390268913 1.8340027153201932e-10 -0.09992145983124598 -2.5811 0.7069686572694391 0.7069672807444263 -8.98587542048912e-10 -0.09992148368092077 -2.5812000000000004 0.7069686998652547 0.706967322460897 -1.9899800540040813e-09 -0.09992150752335612 -2.5813 0.7069687424364353 0.7069673641764058 -3.0905226615710046e-09 -0.09992153135855432 -2.5814 0.7069687849828894 0.7069674058910516 -4.199958724554476e-09 -0.09992155518651753 -2.5815 0.7069688275045287 0.7069674476049299 -5.318029635582866e-09 -0.0999215790072479 -2.5816000000000003 0.7069688700012675 0.7069674893181348 -6.444474866078298e-09 -0.09992160282074763 -2.5817 0.7069689124730227 0.7069675310307566 -7.579032040849754e-09 -0.09992162662701892 -2.5818000000000003 0.7069689549197151 0.7069675727428828 -8.721436988400055e-09 -0.09992165042606399 -2.5819 0.7069689973412671 0.7069676144545988 -9.871423816386338e-09 -0.09992167421788503 -2.582 0.7069690397376045 0.7069676561659862 -1.102872495325341e-08 -0.09992169800248422 -2.5821000000000005 0.7069690821086557 0.7069676978771242 -1.2193071222826868e-08 -0.09992172177986372 -2.5822000000000003 0.7069691244543528 0.7069677395880889 -1.3364191910666262e-08 -0.09992174555002578 -2.5823 0.7069691667746298 0.7069677812989537 -1.4541814819142573e-08 -0.09992176931297252 -2.5824000000000003 0.7069692090694248 0.7069678230097889 -1.572566633205666e-08 -0.09992179306870622 -2.5825 0.7069692513386774 0.7069678647206616 -1.6915471480558747e-08 -0.09992181681722896 -2.5826000000000002 0.7069692935823314 0.7069679064316365 -1.8110954004297436e-08 -0.09992184055854303 -2.5827000000000004 0.7069693358003328 0.7069679481427751 -1.9311836419507594e-08 -0.09992186429265054 -2.5828 0.7069693779926316 0.7069679898541354 -2.0517840078858318e-08 -0.0999218880195537 -2.5829 0.7069694201591795 0.7069680315657731 -2.1728685239107148e-08 -0.09992191173925474 -2.583 0.7069694622999321 0.7069680732777404 -2.2944091125284838e-08 -0.09992193545175576 -2.5831000000000004 0.7069695044148476 0.7069681149900868 -2.4163775995313802e-08 -0.09992195915705902 -2.5832 0.7069695465038874 0.7069681567028583 -2.5387457203325525e-08 -0.09992198285516662 -2.5833000000000004 0.7069695885670162 0.7069681984160986 -2.66148512690495e-08 -0.0999220065460808 -2.5834 0.7069696306042016 0.7069682401298477 -2.7845673943515878e-08 -0.09992203022980378 -2.5835 0.706969672615414 0.7069682818441427 -2.907964026912027e-08 -0.0999220539063377 -2.5836000000000006 0.7069697146006267 0.7069683235590178 -3.031646465161478e-08 -0.0999220775756847 -2.5837000000000003 0.7069697565598169 0.7069683652745038 -3.1555860924075904e-08 -0.09992210123784698 -2.5838 0.7069697984929639 0.7069684069906287 -3.2797542411739863e-08 -0.0999221248928267 -2.5839000000000003 0.7069698404000513 0.7069684487074176 -3.404122200247571e-08 -0.09992214854062616 -2.584 0.7069698822810646 0.7069684904248918 -3.52866122066333e-08 -0.09992217218124742 -2.5841000000000003 0.7069699241359928 0.7069685321430703 -3.653342522935959e-08 -0.09992219581469268 -2.5842 0.7069699659648283 0.7069685738619684 -3.778137303424127e-08 -0.0999222194409641 -2.5843000000000003 0.706970007767566 0.7069686155815984 -3.903016740965798e-08 -0.09992224306006386 -2.5844 0.7069700495442046 0.7069686573019702 -4.027952003697859e-08 -0.0999222666719942 -2.5845 0.7069700912947454 0.7069686990230899 -4.152914255620968e-08 -0.09992229027675725 -2.5846000000000005 0.706970133019193 0.7069687407449605 -4.277874663102051e-08 -0.09992231387435518 -2.5847 0.7069701747175547 0.7069687824675819 -4.4028044019128125e-08 -0.09992233746479014 -2.5848 0.7069702163898416 0.7069688241909513 -4.527674663388679e-08 -0.09992236104806433 -2.5849 0.7069702580360673 0.7069688659150627 -4.6524566614991516e-08 -0.09992238462417993 -2.585 0.7069702996562488 0.7069689076399068 -4.7771216391239834e-08 -0.09992240819313913 -2.5851 0.706970341250406 0.7069689493654712 -4.901640875013078e-08 -0.09992243175494404 -2.5852000000000004 0.7069703828185621 0.7069689910917405 -5.025985690154146e-08 -0.09992245530959691 -2.5853 0.7069704243607431 0.7069690328186966 -5.1501274545137296e-08 -0.09992247885709984 -2.5854 0.7069704658769782 0.7069690745463176 -5.274037593455683e-08 -0.09992250239745507 -2.5855 0.7069705073672998 0.706969116274579 -5.397687594479485e-08 -0.0999225259306647 -2.5856000000000003 0.706970548831743 0.7069691580034531 -5.5210490140615576e-08 -0.09992254945673089 -2.5857 0.7069705902703463 0.7069691997329093 -5.6440934832280645e-08 -0.09992257297565586 -2.5858000000000003 0.7069706316831509 0.7069692414629138 -5.7667927151009574e-08 -0.0999225964874417 -2.5859 0.7069706730702012 0.7069692831934298 -5.8891185109911925e-08 -0.09992261999209062 -2.586 0.7069707144315451 0.7069693249244179 -6.011042766925628e-08 -0.09992264348960486 -2.5861000000000005 0.7069707557672327 0.706969366655835 -6.132537479957081e-08 -0.09992266697998647 -2.5862000000000003 0.7069707970773174 0.7069694083876351 -6.253574754691224e-08 -0.09992269046323767 -2.5863 0.7069708383618556 0.7069694501197699 -6.374126810052005e-08 -0.0999227139393606 -2.5864000000000003 0.7069708796209067 0.7069694918521874 -6.494165984702663e-08 -0.09992273740835741 -2.5865 0.7069709208545331 0.7069695335848329 -6.613664744505032e-08 -0.0999227608702303 -2.5866000000000002 0.7069709620627999 0.7069695753176493 -6.732595688027296e-08 -0.09992278432498142 -2.5867000000000004 0.7069710032457754 0.7069696170505753 -6.850931553266035e-08 -0.09992280777261292 -2.5868 0.7069710444035311 0.7069696587835477 -6.96864522376113e-08 -0.09992283121312695 -2.5869 0.7069710855361404 0.7069697005165001 -7.085709734797399e-08 -0.09992285464652567 -2.587 0.7069711266436806 0.7069697422493635 -7.202098279346023e-08 -0.09992287807281129 -2.5871000000000004 0.7069711677262311 0.7069697839820654 -7.317784214699863e-08 -0.0999229014919859 -2.5872 0.7069712087838749 0.7069698257145312 -7.432741068024579e-08 -0.09992292490405168 -2.5873000000000004 0.706971249816697 0.706969867446683 -7.546942543080679e-08 -0.09992294830901081 -2.5874 0.7069712908247858 0.7069699091784402 -7.660362525644532e-08 -0.09992297170686543 -2.5875 0.7069713318082322 0.7069699509097195 -7.772975089623269e-08 -0.09992299509761765 -2.5876000000000006 0.7069713727671301 0.7069699926404348 -7.88475450295284e-08 -0.09992301848126971 -2.5877000000000003 0.7069714137015757 0.7069700343704974 -7.99567523388639e-08 -0.09992304185782372 -2.5878 0.7069714546116683 0.7069700760998157 -8.105711956068323e-08 -0.09992306522728185 -2.5879000000000003 0.7069714954975097 0.7069701178282951 -8.214839554866044e-08 -0.09992308858964621 -2.588 0.7069715363592046 0.7069701595558389 -8.323033133268015e-08 -0.09992311194491897 -2.5881000000000003 0.7069715771968602 0.7069702012823473 -8.430268016567516e-08 -0.0999231352931023 -2.5882 0.7069716180105862 0.7069702430077185 -8.536519759821948e-08 -0.09992315863419833 -2.5883000000000003 0.7069716588004951 0.7069702847318475 -8.641764151235548e-08 -0.09992318196820926 -2.5884 0.7069716995667016 0.7069703264546269 -8.745977219271756e-08 -0.09992320529513712 -2.5885 0.7069717403093236 0.7069703681759465 -8.849135237250227e-08 -0.09992322861498415 -2.5886000000000005 0.7069717810284812 0.7069704098956942 -8.951214728984691e-08 -0.0999232519277525 -2.5887000000000002 0.7069718217242967 0.7069704516137552 -9.052192474160586e-08 -0.09992327523344434 -2.5888 0.706971862396895 0.7069704933300116 -9.15204551458007e-08 -0.09992329853206174 -2.5889 0.7069719030464037 0.7069705350443438 -9.250751157457993e-08 -0.09992332182360684 -2.589 0.7069719436729527 0.7069705767566299 -9.348286981666898e-08 -0.09992334510808187 -2.5891 0.7069719842766737 0.7069706184667448 -9.444630842854462e-08 -0.09992336838548889 -2.5892000000000004 0.7069720248577019 0.706970660174562 -9.53976087847419e-08 -0.09992339165583014 -2.5893 0.7069720654161742 0.7069707018799518 -9.633655512469169e-08 -0.09992341491910771 -2.5894 0.706972105952229 0.7069707435827829 -9.726293460302765e-08 -0.09992343817532372 -2.5895 0.7069721464660083 0.7069707852829215 -9.817653733555642e-08 -0.09992346142448033 -2.5896000000000003 0.7069721869576553 0.7069708269802315 -9.907715645823822e-08 -0.0999234846665797 -2.5897 0.706972227427316 0.7069708686745745 -9.996458814887088e-08 -0.09992350790162394 -2.5898000000000003 0.7069722678751384 0.7069709103658104 -1.0083863170428503e-07 -0.0999235311296152 -2.5899 0.7069723083012724 0.7069709520537967 -1.0169908956029344e-07 -0.09992355435055562 -2.59 0.7069723487058701 0.7069709937383889 -1.0254576735153897e-07 -0.09992357756444735 -2.5901000000000005 0.7069723890890858 0.7069710354194403 -1.0337847395052585e-07 -0.09992360077129253 -2.5902000000000003 0.7069724294510755 0.7069710770968023 -1.0419702150404886e-07 -0.09992362397109326 -2.5903 0.7069724697919975 0.7069711187703243 -1.0500122548696977e-07 -0.09992364716385176 -2.5904000000000003 0.7069725101120119 0.7069711604398539 -1.0579090474558545e-07 -0.09992367034957007 -2.5905 0.7069725504112804 0.7069712021052362 -1.0656588151670976e-07 -0.09992369352825033 -2.5906000000000002 0.7069725906899673 0.7069712437663156 -1.0732598149706257e-07 -0.09992371669989475 -2.5907000000000004 0.706972630948238 0.7069712854229333 -1.0807103385541278e-07 -0.09992373986450542 -2.5908 0.7069726711862603 0.7069713270749296 -1.0880087129155891e-07 -0.09992376302208449 -2.5909 0.7069727114042033 0.7069713687221428 -1.0951533006148262e-07 -0.09992378617263406 -2.591 0.7069727516022377 0.7069714103644098 -1.1021425002158414e-07 -0.09992380931615633 -2.5911000000000004 0.7069727917805362 0.7069714520015651 -1.1089747465990729e-07 -0.09992383245265331 -2.5912 0.7069728319392733 0.7069714936334421 -1.1156485113170134e-07 -0.09992385558212724 -2.5913000000000004 0.7069728720786247 0.7069715352598727 -1.122162302923807e-07 -0.09992387870458021 -2.5914 0.706972912198768 0.7069715768806866 -1.1285146673915836e-07 -0.0999239018200144 -2.5915 0.7069729522998817 0.706971618495713 -1.1347041883012776e-07 -0.09992392492843188 -2.5916000000000006 0.7069729923821464 0.7069716601047786 -1.1407294873110041e-07 -0.09992394802983479 -2.5917000000000003 0.7069730324457438 0.706971701707709 -1.1465892242427944e-07 -0.09992397112422517 -2.5918 0.7069730724908574 0.7069717433043288 -1.1522820976550552e-07 -0.0999239942116053 -2.5919 0.7069731125176719 0.7069717848944612 -1.1578068448425682e-07 -0.09992401729197731 -2.592 0.7069731525263727 0.7069718264779272 -1.1631622424956856e-07 -0.09992404036534319 -2.5921000000000003 0.7069731925171471 0.7069718680545476 -1.1683471064921624e-07 -0.09992406343170514 -2.5922 0.7069732324901835 0.7069719096241414 -1.173360292521658e-07 -0.09992408649106527 -2.5923000000000003 0.7069732724456714 0.7069719511865268 -1.1782006962245128e-07 -0.09992410954342573 -2.5924 0.7069733123838015 0.7069719927415204 -1.1828672534172635e-07 -0.09992413258878863 -2.5925 0.7069733523047654 0.7069720342889381 -1.1873589403701978e-07 -0.09992415562715605 -2.5926000000000005 0.7069733922087562 0.7069720758285944 -1.1916747739981748e-07 -0.09992417865853019 -2.5927000000000002 0.7069734320959675 0.7069721173603034 -1.1958138120340966e-07 -0.0999242016829131 -2.5928 0.7069734719665943 0.7069721588838773 -1.199775153306465e-07 -0.09992422470030694 -2.5929 0.706973511820832 0.7069722003991286 -1.2035579378608108e-07 -0.09992424771071386 -2.593 0.7069735516588773 0.7069722419058679 -1.2071613472892928e-07 -0.09992427071413597 -2.5931 0.7069735914809275 0.7069722834039049 -1.2105846047133495e-07 -0.09992429371057529 -2.5932000000000004 0.7069736312871808 0.7069723248930496 -1.213826975130644e-07 -0.09992431670003404 -2.5933 0.706973671077836 0.7069723663731101 -1.2168877654150645e-07 -0.09992433968251428 -2.5934 0.7069737108530929 0.7069724078438945 -1.219766324576932e-07 -0.09992436265801816 -2.5935 0.7069737506131517 0.7069724493052103 -1.222462043849737e-07 -0.09992438562654782 -2.5936000000000003 0.7069737903582133 0.7069724907568636 -1.2249743568289173e-07 -0.09992440858810535 -2.5937 0.7069738300884788 0.7069725321986607 -1.2273027396106362e-07 -0.09992443154269282 -2.5938000000000003 0.7069738698041503 0.7069725736304073 -1.2294467108438234e-07 -0.09992445449031238 -2.5939 0.7069739095054302 0.7069726150519087 -1.231405831816912e-07 -0.09992447743096616 -2.594 0.7069739491925212 0.706972656462969 -1.2331797066833516e-07 -0.09992450036465628 -2.5941000000000005 0.7069739888656265 0.706972697863393 -1.234767982409568e-07 -0.09992452329138479 -2.5942000000000003 0.7069740285249494 0.7069727392529845 -1.2361703489657816e-07 -0.09992454621115386 -2.5943 0.7069740681706937 0.7069727806315473 -1.2373865391698824e-07 -0.09992456912396556 -2.5944000000000003 0.7069741078030638 0.706972821998885 -1.2384163288782501e-07 -0.09992459202982204 -2.5945 0.7069741474222635 0.7069728633548005 -1.239259537055143e-07 -0.0999246149287254 -2.5946000000000002 0.7069741870284973 0.7069729046990973 -1.2399160257900443e-07 -0.09992463782067776 -2.5947000000000005 0.7069742266219694 0.7069729460315786 -1.2403857002282748e-07 -0.0999246607056812 -2.5948 0.7069742662028842 0.7069729873520468 -1.2406685087618108e-07 -0.09992468358373784 -2.5949 0.7069743057714463 0.7069730286603055 -1.2407644427343822e-07 -0.09992470645484976 -2.595 0.7069743453278602 0.7069730699561576 -1.2406735366322919e-07 -0.09992472931901915 -2.5951000000000004 0.7069743848723301 0.706973111239406 -1.2403958681017624e-07 -0.09992475217624802 -2.5952 0.7069744244050602 0.7069731525098539 -1.2399315577581171e-07 -0.09992477502653851 -2.5953000000000004 0.7069744639262545 0.7069731937673049 -1.239280769411294e-07 -0.09992479786989271 -2.5954 0.7069745034361168 0.706973235011563 -1.2384437096668588e-07 -0.09992482070631276 -2.5955 0.7069745429348505 0.7069732762424317 -1.2374206280647837e-07 -0.09992484353580075 -2.5956000000000006 0.7069745824226588 0.7069733174597155 -1.236211816958016e-07 -0.09992486635835876 -2.5957000000000003 0.7069746218997447 0.7069733586632189 -1.2348176115818676e-07 -0.09992488917398894 -2.5958 0.7069746613663104 0.7069733998527472 -1.2332383897070698e-07 -0.09992491198269338 -2.5959 0.7069747008225575 0.7069734410281056 -1.2314745717785514e-07 -0.09992493478447409 -2.596 0.7069747402686879 0.7069734821891 -1.2295266205858413e-07 -0.09992495757933324 -2.5961000000000003 0.7069747797049023 0.7069735233355376 -1.2273950412110268e-07 -0.09992498036727297 -2.5962 0.7069748191314011 0.7069735644672254 -1.2250803811154898e-07 -0.09992500314829539 -2.5963000000000003 0.7069748585483837 0.7069736055839707 -1.2225832297582673e-07 -0.0999250259224025 -2.5964 0.7069748979560493 0.7069736466855822 -1.2199042184919684e-07 -0.09992504868959644 -2.5965 0.7069749373545958 0.7069736877718693 -1.2170440204239963e-07 -0.09992507144987932 -2.5966000000000005 0.706974976744221 0.7069737288426419 -1.2140033502257286e-07 -0.09992509420325328 -2.5967000000000002 0.7069750161251214 0.7069737698977105 -1.210782964028434e-07 -0.09992511694972035 -2.5968 0.7069750554974925 0.706973810936887 -1.2073836592324527e-07 -0.0999251396892826 -2.5969 0.7069750948615294 0.7069738519599842 -1.2038062741602518e-07 -0.09992516242194219 -2.597 0.7069751342174257 0.7069738929668151 -1.2000516880390777e-07 -0.09992518514770116 -2.5971 0.7069751735653744 0.7069739339571945 -1.196120820740748e-07 -0.09992520786656162 -2.5972000000000004 0.7069752129055676 0.706973974930938 -1.1920146323479708e-07 -0.09992523057852569 -2.5973 0.706975252238196 0.7069740158878624 -1.1877341233451633e-07 -0.09992525328359546 -2.5974 0.7069752915634493 0.7069740568277849 -1.1832803339245634e-07 -0.099925275981773 -2.5975 0.7069753308815155 0.7069740977505248 -1.178654344020924e-07 -0.09992529867306038 -2.5976000000000004 0.7069753701925825 0.7069741386559021 -1.1738572729472208e-07 -0.09992532135745975 -2.5977 0.7069754094968361 0.7069741795437384 -1.1688902791344435e-07 -0.09992534403497318 -2.5978000000000003 0.7069754487944608 0.706974220413856 -1.1637545598713883e-07 -0.0999253667056027 -2.5979 0.7069754880856401 0.7069742612660792 -1.1584513509750594e-07 -0.09992538936935046 -2.598 0.7069755273705562 0.7069743021002333 -1.152981926617197e-07 -0.09992541202621853 -2.5981000000000005 0.7069755666493895 0.7069743429161449 -1.1473475987691661e-07 -0.09992543467620901 -2.5982000000000003 0.7069756059223194 0.7069743837136425 -1.141549717184609e-07 -0.099925457319324 -2.5983 0.7069756451895233 0.7069744244925558 -1.1355896688963751e-07 -0.09992547995556551 -2.5984000000000003 0.7069756844511773 0.706974465252716 -1.1294688778695772e-07 -0.09992550258493574 -2.5985 0.7069757237074561 0.7069745059939561 -1.1231888048107708e-07 -0.0999255252074367 -2.5986000000000002 0.7069757629585325 0.7069745467161102 -1.1167509466475378e-07 -0.09992554782307046 -2.5987000000000005 0.7069758022045776 0.7069745874190143 -1.1101568363203196e-07 -0.0999255704318391 -2.5988 0.7069758414457614 0.7069746281025067 -1.1034080422099579e-07 -0.09992559303374475 -2.5989 0.7069758806822514 0.7069746687664269 -1.0965061680683064e-07 -0.09992561562878949 -2.599 0.7069759199142136 0.7069747094106158 -1.0894528524284242e-07 -0.09992563821697535 -2.5991000000000004 0.7069759591418125 0.7069747500349168 -1.0822497682055898e-07 -0.09992566079830448 -2.5992 0.7069759983652105 0.7069747906391749 -1.0748986224457663e-07 -0.09992568337277889 -2.5993000000000004 0.706976037584568 0.7069748312232367 -1.0674011557357949e-07 -0.0999257059404007 -2.5994 0.7069760768000438 0.7069748717869508 -1.0597591419084923e-07 -0.09992572850117198 -2.5995 0.7069761160117946 0.7069749123301683 -1.051974387652338e-07 -0.09992575105509481 -2.5996000000000006 0.7069761552199749 0.7069749528527413 -1.0440487320084041e-07 -0.09992577360217125 -2.5997000000000003 0.7069761944247375 0.7069749933545246 -1.0359840459887165e-07 -0.09992579614240336 -2.5998 0.7069762336262331 0.7069750338353751 -1.027782232003796e-07 -0.09992581867579328 -2.5999 0.7069762728246101 0.7069750742951515 -1.0194452236631651e-07 -0.09992584120234302 -2.6 0.7069763120200152 0.7069751147337149 -1.0109749850554378e-07 -0.09992586372205471 -2.6001000000000003 0.7069763512125928 0.706975155150928 -1.0023735105488263e-07 -0.09992588623493044 -2.6002 0.7069763904024847 0.7069751955466561 -9.936428240278627e-08 -0.09992590874097224 -2.6003000000000003 0.7069764295898309 0.7069752359207668 -9.84784978650538e-08 -0.09992593124018218 -2.6004 0.706976468774769 0.7069752762731297 -9.758020562671693e-08 -0.09992595373256234 -2.6005 0.7069765079574345 0.7069753166036167 -9.66696166943351e-08 -0.09992597621811478 -2.6006000000000005 0.7069765471379603 0.706975356912102 -9.574694485176005e-08 -0.09992599869684159 -2.6007000000000002 0.7069765863164775 0.7069753971984623 -9.481240660202256e-08 -0.09992602116874484 -2.6008 0.7069766254931141 0.7069754374625763 -9.386622112049492e-08 -0.09992604363382658 -2.6009 0.7069766646679962 0.7069754777043253 -9.290861019764507e-08 -0.09992606609208887 -2.601 0.706976703841248 0.7069755179235934 -9.193979819827058e-08 -0.09992608854353385 -2.6011 0.7069767430129897 0.7069755581202666 -9.096001199904863e-08 -0.09992611098816355 -2.6012000000000004 0.7069767821833408 0.7069755982942332 -8.996948094776996e-08 -0.09992613342598 -2.6013 0.7069768213524167 0.7069756384453847 -8.896843679048055e-08 -0.09992615585698525 -2.6014 0.7069768605203317 0.7069756785736145 -8.79571136367871e-08 -0.09992617828118146 -2.6015 0.7069768996871969 0.706975718678819 -8.693574788613129e-08 -0.09992620069857065 -2.6016000000000004 0.7069769388531206 0.7069757587608969 -8.590457819396269e-08 -0.09992622310915486 -2.6017 0.7069769780182087 0.7069757988197494 -8.486384540148245e-08 -0.09992624551293618 -2.6018000000000003 0.7069770171825647 0.7069758388552806 -8.381379248099952e-08 -0.09992626790991667 -2.6019 0.7069770563462893 0.706975878867397 -8.275466448388891e-08 -0.09992629030009836 -2.602 0.7069770955094805 0.7069759188560076 -8.168670847640697e-08 -0.09992631268348333 -2.6021000000000005 0.706977134672234 0.7069759588210249 -8.061017348678229e-08 -0.0999263350600737 -2.6022000000000003 0.706977173834642 0.7069759987623632 -7.952531045057193e-08 -0.09992635742987148 -2.6023 0.7069772129967947 0.7069760386799397 -7.843237214821136e-08 -0.09992637979287872 -2.6024000000000003 0.7069772521587794 0.7069760785736746 -7.733161314343179e-08 -0.09992640214909748 -2.6025 0.7069772913206802 0.7069761184434908 -7.622328972948372e-08 -0.09992642449852986 -2.6026000000000002 0.7069773304825793 0.7069761582893138 -7.510765986018172e-08 -0.09992644684117788 -2.6027000000000005 0.7069773696445553 0.7069761981110719 -7.398498310783735e-08 -0.09992646917704362 -2.6028000000000002 0.7069774088066842 0.7069762379086963 -7.285552058172717e-08 -0.09992649150612909 -2.6029 0.7069774479690398 0.7069762776821216 -7.171953488515834e-08 -0.09992651382843648 -2.603 0.7069774871316916 0.7069763174312838 -7.057729004261021e-08 -0.09992653614396768 -2.6031000000000004 0.7069775262947078 0.7069763571561227 -6.942905144075376e-08 -0.09992655845272479 -2.6032 0.7069775654581529 0.7069763968565816 -6.827508577077201e-08 -0.09992658075470992 -2.6033000000000004 0.706977604622089 0.7069764365326054 -6.71156609615732e-08 -0.09992660304992512 -2.6034 0.7069776437865747 0.7069764761841424 -6.59510461242796e-08 -0.09992662533837238 -2.6035 0.7069776829516663 0.7069765158111438 -6.478151148457331e-08 -0.0999266476200538 -2.6036000000000006 0.7069777221174166 0.7069765554135642 -6.360732832067992e-08 -0.09992666989497144 -2.6037000000000003 0.7069777612838761 0.7069765949913605 -6.242876889744897e-08 -0.09992669216312736 -2.6038 0.7069778004510918 0.7069766345444923 -6.124610641171022e-08 -0.09992671442452356 -2.6039 0.7069778396191081 0.7069766740729231 -6.005961492331832e-08 -0.09992673667916212 -2.604 0.7069778787879664 0.7069767135766184 -5.88695692892334e-08 -0.09992675892704508 -2.6041000000000003 0.7069779179577048 0.7069767530555473 -5.767624510519091e-08 -0.0999267811681745 -2.6042 0.7069779571283589 0.7069767925096815 -5.6479918640432725e-08 -0.0999268034025524 -2.6043000000000003 0.7069779962999612 0.7069768319389962 -5.528086677092023e-08 -0.0999268256301809 -2.6044 0.7069780354725412 0.7069768713434691 -5.407936691796851e-08 -0.09992684785106204 -2.6045 0.7069780746461249 0.7069769107230806 -5.2875696985579465e-08 -0.09992687006519779 -2.6046000000000005 0.7069781138207363 0.7069769500778145 -5.1670135290836014e-08 -0.0999268922725902 -2.6047000000000002 0.7069781529963957 0.7069769894076579 -5.046296050557203e-08 -0.09992691447324138 -2.6048 0.7069781921731204 0.7069770287126003 -4.925445158774234e-08 -0.09992693666715331 -2.6049 0.706978231350925 0.7069770679926344 -4.8044887719297935e-08 -0.09992695885432806 -2.605 0.706978270529821 0.7069771072477562 -4.683454824135069e-08 -0.0999269810347677 -2.6051 0.7069783097098169 0.7069771464779644 -4.562371258765756e-08 -0.09992700320847425 -2.6052000000000004 0.706978348890918 0.7069771856832606 -4.4412660224555766e-08 -0.09992702537544972 -2.6053 0.7069783880731271 0.7069772248636498 -4.3201670579147964e-08 -0.09992704753569621 -2.6054 0.7069784272564434 0.7069772640191399 -4.199102298360814e-08 -0.0999270696892158 -2.6055 0.7069784664408635 0.706977303149741 -4.0780996605338645e-08 -0.09992709183601045 -2.6056000000000004 0.7069785056263809 0.7069773422554673 -3.9571870382229795e-08 -0.09992711397608219 -2.6057 0.7069785448129857 0.7069773813363356 -3.8363922963218465e-08 -0.0999271361094331 -2.6058000000000003 0.7069785840006659 0.7069774203923654 -3.7157432637171216e-08 -0.09992715823606522 -2.6059 0.7069786231894057 0.7069774594235797 -3.5952677274967565e-08 -0.0999271803559806 -2.606 0.7069786623791867 0.7069774984300039 -3.474993426279445e-08 -0.09992720246918124 -2.6061000000000005 0.7069787015699875 0.7069775374116667 -3.35494804366062e-08 -0.09992722457566919 -2.6062000000000003 0.7069787407617838 0.7069775763685997 -3.2351592022710277e-08 -0.0999272466754465 -2.6063 0.7069787799545478 0.7069776153008376 -3.115654457217301e-08 -0.09992726876851514 -2.6064000000000003 0.7069788191482493 0.7069776542084178 -2.996461289555066e-08 -0.0999272908548772 -2.6065 0.7069788583428553 0.706977693091381 -2.8776071003041442e-08 -0.09992731293453476 -2.6066000000000003 0.7069788975383295 0.7069777319497704 -2.7591192037048143e-08 -0.09992733500748978 -2.6067000000000005 0.7069789367346324 0.7069777707836324 -2.6410248215365945e-08 -0.0999273570737443 -2.6068000000000002 0.7069789759317227 0.7069778095930164 -2.52335107635282e-08 -0.09992737913330044 -2.6069 0.706979015129555 0.7069778483779741 -2.406124985452479e-08 -0.09992740118616013 -2.607 0.7069790543280811 0.7069778871385607 -2.289373454830365e-08 -0.09992742323232537 -2.6071000000000004 0.706979093527251 0.7069779258748343 -2.1731232728236516e-08 -0.09992744527179835 -2.6072 0.7069791327270107 0.7069779645868557 -2.0574011039102558e-08 -0.09992746730458099 -2.6073000000000004 0.7069791719273038 0.7069780032746882 -1.9422334825939386e-08 -0.0999274893306753 -2.6074 0.706979211128071 0.7069780419383983 -1.827646807723085e-08 -0.09992751135008335 -2.6075 0.7069792503292507 0.7069780805780554 -1.7136673358987553e-08 -0.09992753336280719 -2.6076000000000006 0.7069792895307775 0.7069781191937314 -1.600321175793465e-08 -0.0999275553688488 -2.6077000000000004 0.7069793287325838 0.7069781577855012 -1.4876342819929167e-08 -0.09992757736821022 -2.6078 0.7069793679345995 0.7069781963534423 -1.3756324491413091e-08 -0.09992759936089346 -2.6079 0.7069794071367509 0.7069782348976353 -1.2643413062601166e-08 -0.0999276213469006 -2.608 0.7069794463389625 0.7069782734181631 -1.1537863101995088e-08 -0.0999276433262336 -2.6081000000000003 0.7069794855411553 0.7069783119151114 -1.0439927406943883e-08 -0.09992766529889452 -2.6082 0.7069795247432483 0.706978350388569 -9.349856943362267e-09 -0.0999276872648854 -2.6083000000000003 0.7069795639451577 0.706978388838627 -8.267900781545878e-09 -0.0999277092242083 -2.6084 0.7069796031467963 0.706978427265379 -7.1943060441295725e-09 -0.09992773117686514 -2.6085 0.7069796423480752 0.7069784656689216 -6.129317856214123e-09 -0.09992775312285802 -2.6086000000000005 0.7069796815489022 0.7069785040493537 -5.073179277712003e-09 -0.09992777506218889 -2.6087000000000002 0.706979720749183 0.7069785424067769 -4.026131256509857e-09 -0.0999277969948598 -2.6088 0.7069797599488207 0.7069785807412957 -2.988412570355259e-09 -0.09992781892087282 -2.6089 0.7069797991477156 0.7069786190530167 -1.9602597722129245e-09 -0.09992784084022997 -2.609 0.7069798383457657 0.7069786573420489 -9.419071338861995e-10 -0.09992786275293322 -2.6091 0.7069798775428662 0.7069786956085038 6.641340168783705e-11 -0.0999278846589845 -2.6092000000000004 0.7069799167389099 0.7069787338524961 1.064472275949524e-09 -0.09992790655838599 -2.6093 0.7069799559337879 0.7069787720741423 2.0520423693604073e-09 -0.09992792845113962 -2.6094 0.7069799951273881 0.7069788102735614 3.0288990465060506e-09 -0.09992795033724747 -2.6095 0.706980034319596 0.7069788484508747 3.9948202176787184e-09 -0.09992797221671149 -2.6096000000000004 0.7069800735102953 0.7069788866062061 4.9495863753065694e-09 -0.09992799408953376 -2.6097 0.7069801126993666 0.7069789247396816 5.8929806590057865e-09 -0.09992801595571621 -2.6098000000000003 0.7069801518866888 0.7069789628514295 6.824788891142408e-09 -0.09992803781526087 -2.6099 0.7069801910721389 0.7069790009415806 7.74479963754765e-09 -0.09992805966816987 -2.61 0.7069802302555908 0.7069790390102677 8.652804242212375e-09 -0.09992808151444511 -2.6101000000000005 0.7069802694369163 0.706979077057626 9.548596888002414e-09 -0.09992810335408864 -2.6102000000000003 0.7069803086159854 0.7069791150837923 1.0431974640026653e-08 -0.09992812518710242 -2.6103 0.7069803477926659 0.7069791530889067 1.1302737482066227e-08 -0.09992814701348852 -2.6104000000000003 0.7069803869668234 0.7069791910731101 1.2160688370350947e-08 -0.09992816883324895 -2.6105 0.7069804261383217 0.7069792290365466 1.300563327345794e-08 -0.09992819064638575 -2.6106000000000003 0.7069804653070217 0.7069792669793615 1.3837381227822798e-08 -0.09992821245290084 -2.6107000000000005 0.7069805044727833 0.7069793049017024 1.4655744362025713e-08 -0.09992823425279629 -2.6108000000000002 0.7069805436354637 0.7069793428037188 1.5460537954904707e-08 -0.099928256046074 -2.6109 0.7069805827949187 0.7069793806855624 1.625158047371955e-08 -0.09992827783273615 -2.611 0.7069806219510018 0.706979418547387 1.7028693602774703e-08 -0.09992829961278461 -2.6111000000000004 0.7069806611035648 0.7069794563893474 1.7791702304134627e-08 -0.09992832138622149 -2.6112 0.7069807002524577 0.7069794942116014 1.8540434841042563e-08 -0.09992834315304874 -2.6113000000000004 0.7069807393975285 0.7069795320143075 1.9274722825625423e-08 -0.09992836491326836 -2.6114 0.7069807785386235 0.7069795697976267 1.9994401246649363e-08 -0.09992838666688239 -2.6115 0.7069808176755872 0.7069796075617212 2.069930852242885e-08 -0.09992840841389275 -2.6116 0.7069808568082627 0.7069796453067554 2.138928652251071e-08 -0.09992843015430156 -2.6117000000000004 0.7069808959364914 0.7069796830328949 2.2064180601501227e-08 -0.09992845188811073 -2.6118 0.7069809350601125 0.7069797207403077 2.2723839653709943e-08 -0.09992847361532227 -2.6119 0.7069809741789643 0.7069797584291622 2.3368116126160077e-08 -0.09992849533593823 -2.612 0.7069810132928835 0.7069797960996291 2.399686606022189e-08 -0.09992851704996059 -2.6121000000000003 0.7069810524017053 0.7069798337518807 2.4609949121970343e-08 -0.09992853875739136 -2.6122 0.7069810915052626 0.7069798713860902 2.5207228630808043e-08 -0.09992856045823251 -2.6123000000000003 0.7069811306033879 0.7069799090024329 2.578857160283332e-08 -0.09992858215248608 -2.6124 0.7069811696959121 0.7069799466010847 2.6353848759513854e-08 -0.09992860384015403 -2.6125 0.7069812087826641 0.7069799841822234 2.6902934579728366e-08 -0.09992862552123837 -2.6126000000000005 0.7069812478634725 0.7069800217460283 2.743570730323608e-08 -0.09992864719574107 -2.6127000000000002 0.706981286938164 0.7069800592926793 2.7952048972310073e-08 -0.0999286688636642 -2.6128 0.706981326006564 0.7069800968223582 2.8451845461227587e-08 -0.09992869052500974 -2.6129000000000002 0.7069813650684973 0.7069801343352471 2.8934986493617254e-08 -0.09992871217977962 -2.613 0.7069814041237872 0.7069801718315301 2.940136566847995e-08 -0.09992873382797592 -2.6131 0.7069814431722554 0.7069802093113919 2.985088047927076e-08 -0.09992875546960056 -2.6132000000000004 0.7069814822137235 0.7069802467750181 3.028343234685871e-08 -0.09992877710465549 -2.6133 0.7069815212480115 0.7069802842225963 3.0698926628200396e-08 -0.09992879873314287 -2.6134 0.706981560274939 0.7069803216543138 3.109727265103446e-08 -0.09992882035506458 -2.6135 0.7069815992943235 0.7069803590703598 3.1478383719085734e-08 -0.0999288419704226 -2.6136000000000004 0.7069816383059829 0.7069803964709237 3.184217714502502e-08 -0.09992886357921897 -2.6137 0.7069816773097335 0.706980433856196 3.218857425914268e-08 -0.09992888518145562 -2.6138000000000003 0.7069817163053913 0.7069804712263681 3.251750043363477e-08 -0.09992890677713463 -2.6139 0.7069817552927711 0.7069805085816322 3.2828885077398895e-08 -0.09992892836625794 -2.614 0.706981794271687 0.706980545922181 3.3122661679402254e-08 -0.09992894994882752 -2.6141000000000005 0.7069818332419526 0.7069805832482077 3.3398767813885843e-08 -0.09992897152484537 -2.6142000000000003 0.7069818722033812 0.7069806205599063 3.365714513862972e-08 -0.09992899309431344 -2.6143 0.7069819111557851 0.7069806578574719 3.3897739433116914e-08 -0.09992901465723382 -2.6144000000000003 0.7069819500989761 0.7069806951410993 3.412050058118621e-08 -0.09992903621360844 -2.6145 0.7069819890327658 0.706980732410984 3.432538260225715e-08 -0.09992905776343924 -2.6146000000000003 0.7069820279569649 0.7069807696673225 3.4512343660003664e-08 -0.09992907930672826 -2.6147000000000005 0.7069820668713839 0.7069808069103107 3.4681346055415174e-08 -0.09992910084347745 -2.6148000000000002 0.706982105775833 0.7069808441401461 3.483235625108272e-08 -0.0999291223736888 -2.6149 0.7069821446701223 0.7069808813570253 3.496534485732117e-08 -0.09992914389736435 -2.615 0.7069821835540615 0.7069809185611462 3.508028666512897e-08 -0.09992916541450603 -2.6151000000000004 0.7069822224274598 0.7069809557527061 3.5177160627106185e-08 -0.09992918692511589 -2.6152 0.7069822612901263 0.7069809929319026 3.525594987133229e-08 -0.09992920842919577 -2.6153000000000004 0.7069823001418702 0.7069810300989339 3.531664171524396e-08 -0.09992922992674774 -2.6154 0.7069823389825005 0.7069810672539978 3.5359227637879465e-08 -0.09992925141777378 -2.6155 0.7069823778118263 0.7069811043972924 3.538370330589957e-08 -0.09992927290227582 -2.6156 0.7069824166296564 0.7069811415290161 3.5390068557974996e-08 -0.09992929438025598 -2.6157000000000004 0.7069824554358002 0.7069811786493665 3.53783274186642e-08 -0.09992931585171612 -2.6158 0.7069824942300662 0.7069812157585416 3.534848809320923e-08 -0.09992933731665822 -2.6159 0.706982533012264 0.706981252856739 3.530056294324957e-08 -0.09992935877508427 -2.616 0.7069825717822033 0.7069812899441563 3.5234568509373565e-08 -0.09992938022699628 -2.6161000000000003 0.7069826105396932 0.7069813270209909 3.515052549030173e-08 -0.09992940167239621 -2.6162 0.7069826492845441 0.70698136408744 3.5048458742886757e-08 -0.09992942311128603 -2.6163000000000003 0.7069826880165662 0.7069814011436999 3.492839728384822e-08 -0.09992944454366769 -2.6164 0.7069827267355697 0.7069814381899673 3.4790374253343415e-08 -0.09992946596954316 -2.6165 0.7069827654413658 0.7069814752264381 3.4634426942722896e-08 -0.09992948738891445 -2.6166000000000005 0.7069828041337662 0.7069815122533077 3.446059676677493e-08 -0.09992950880178351 -2.6167000000000002 0.7069828428125828 0.7069815492707713 3.426892923423519e-08 -0.09992953020815232 -2.6168 0.7069828814776281 0.7069815862790232 3.40594739668687e-08 -0.09992955160802287 -2.6169000000000002 0.706982920128715 0.7069816232782575 3.383228468385735e-08 -0.09992957300139713 -2.617 0.7069829587656575 0.7069816602686672 3.35874191601665e-08 -0.09992959438827703 -2.6171 0.7069829973882698 0.706981697250445 3.332493924909641e-08 -0.09992961576866456 -2.6172000000000004 0.706983035996367 0.7069817342237827 3.304491083370997e-08 -0.09992963714256171 -2.6173 0.7069830745897651 0.7069817711888717 3.274740383030217e-08 -0.09992965850997047 -2.6174 0.7069831131682807 0.7069818081459021 3.2432492164113924e-08 -0.09992967987089275 -2.6175 0.7069831517317311 0.706981845095063 3.210025376239323e-08 -0.09992970122533053 -2.6176000000000004 0.7069831902799351 0.7069818820365437 3.175077051796593e-08 -0.0999297225732858 -2.6177 0.7069832288127116 0.7069819189705311 3.138412827188852e-08 -0.0999297439147605 -2.6178000000000003 0.706983267329881 0.7069819558972121 3.100041681518284e-08 -0.0999297652497566 -2.6179 0.7069833058312647 0.7069819928167731 3.059972982291659e-08 -0.09992978657827613 -2.618 0.7069833443166852 0.7069820297293978 3.018216488022418e-08 -0.09992980790032101 -2.6181000000000005 0.7069833827859655 0.7069820666352702 2.974782342853033e-08 -0.09992982921589315 -2.6182000000000003 0.7069834212389304 0.7069821035345722 2.9296810744733337e-08 -0.09992985052499456 -2.6183 0.7069834596754059 0.7069821404274853 2.8829235932531505e-08 -0.0999298718276272 -2.6184000000000003 0.7069834980952185 0.7069821773141893 2.8345211866911968e-08 -0.09992989312379304 -2.6185 0.7069835364981968 0.7069822141948634 2.7844855187211803e-08 -0.09992991441349407 -2.6186000000000003 0.7069835748841702 0.7069822510696845 2.732828626589301e-08 -0.0999299356967322 -2.6187000000000005 0.7069836132529697 0.7069822879388288 2.67956291859911e-08 -0.09992995697350941 -2.6188000000000002 0.7069836516044272 0.706982324802471 2.6247011697747014e-08 -0.09992997824382766 -2.6189 0.7069836899383766 0.7069823616607844 2.5682565196055718e-08 -0.09992999950768887 -2.619 0.7069837282546532 0.7069823985139408 2.5102424687506453e-08 -0.09993002076509507 -2.6191000000000004 0.7069837665530933 0.7069824353621105 2.450672875742299e-08 -0.09993004201604817 -2.6192 0.7069838048335353 0.7069824722054622 2.3895619535169166e-08 -0.09993006326055015 -2.6193 0.7069838430958186 0.7069825090441634 2.326924266292385e-08 -0.099930084498603 -2.6194 0.7069838813397848 0.7069825458783792 2.262774726792538e-08 -0.09993010573020858 -2.6195 0.7069839195652766 0.7069825827082739 2.1971285912164573e-08 -0.09993012695536889 -2.6196 0.7069839577721391 0.7069826195340099 2.1300014569833325e-08 -0.09993014817408592 -2.6197000000000004 0.7069839959602182 0.7069826563557475 2.0614092581354437e-08 -0.09993016938636162 -2.6198 0.7069840341293622 0.7069826931736456 1.9913682612615613e-08 -0.09993019059219792 -2.6199 0.7069840722794211 0.7069827299878612 1.9198950633285417e-08 -0.09993021179159678 -2.62 0.7069841104102463 0.7069827667985494 1.847006585609795e-08 -0.09993023298456015 -2.6201000000000003 0.7069841485216914 0.7069828036058634 1.7727200710832003e-08 -0.09993025417108992 -2.6202 0.7069841866136124 0.7069828404099551 1.697053080441241e-08 -0.09993027535118813 -2.6203000000000003 0.7069842246858664 0.7069828772109739 1.620023487060307e-08 -0.09993029652485677 -2.6204 0.7069842627383125 0.7069829140090669 1.5416494737047204e-08 -0.09993031769209769 -2.6205 0.7069843007708122 0.7069829508043802 1.4619495271490923e-08 -0.09993033885291287 -2.6206000000000005 0.7069843387832289 0.7069829875970571 1.3809424343619314e-08 -0.09993036000730426 -2.6207000000000003 0.7069843767754278 0.706983024387239 1.2986472789494607e-08 -0.0999303811552738 -2.6208 0.7069844147472767 0.7069830611750657 1.2150834352575579e-08 -0.0999304022968235 -2.6209000000000002 0.7069844526986451 0.7069830979606742 1.1302705643818911e-08 -0.09993042343195524 -2.621 0.7069844906294045 0.7069831347441994 1.0442286100045828e-08 -0.09993044456067096 -2.6211 0.7069845285394292 0.7069831715257744 9.569777932767753e-09 -0.09993046568297263 -2.6212000000000004 0.7069845664285953 0.7069832083055301 8.68538607701197e-09 -0.09993048679886223 -2.6213 0.7069846042967812 0.7069832450835949 7.789318151422975e-09 -0.09993050790834168 -2.6214 0.7069846421438675 0.706983281860095 6.881784393210355e-09 -0.09993052901141292 -2.6215 0.706984679969737 0.7069833186351544 5.962997639934187e-09 -0.09993055010807789 -2.6216000000000004 0.7069847177742751 0.7069833554088947 5.0331732462383094e-09 -0.09993057119833852 -2.6217 0.7069847555573692 0.7069833921814351 4.0925290526253044e-09 -0.09993059228219674 -2.6218000000000004 0.7069847933189093 0.7069834289528929 3.1412853325474277e-09 -0.09993061335965456 -2.6219 0.7069848310587878 0.7069834657233822 2.179664730823927e-09 -0.09993063443071387 -2.622 0.7069848687768996 0.7069835024930153 1.2078922211403165e-09 -0.09993065549537666 -2.6221000000000005 0.7069849064731419 0.7069835392619019 2.2619505313931088e-10 -0.09993067655364485 -2.6222000000000003 0.7069849441474142 0.706983576030149 -7.651973039576876e-10 -0.09993069760552031 -2.6223 0.7069849817996187 0.7069836127978613 -1.7660532142596552e-09 -0.09993071865100504 -2.6224000000000003 0.70698501942966 0.7069836495651411 -2.776138927247651e-09 -0.09993073969010097 -2.6225 0.7069850570374454 0.7069836863320882 -3.795218638490139e-09 -0.09993076072281006 -2.6226000000000003 0.7069850946228848 0.7069837230987993 -4.82305453648052e-09 -0.09993078174913421 -2.6227000000000005 0.7069851321858904 0.7069837598653692 -5.8594068633524565e-09 -0.09993080276907539 -2.6228000000000002 0.7069851697263773 0.7069837966318897 -6.904033967788936e-09 -0.0999308237826355 -2.6229 0.7069852072442628 0.7069838333984497 -7.956692365737594e-09 -0.0999308447898165 -2.623 0.7069852447394674 0.7069838701651365 -9.017136790717695e-09 -0.09993086579062033 -2.6231000000000004 0.706985282211914 0.7069839069320337 -1.0085120259739622e-08 -0.09993088678504891 -2.6232 0.706985319661528 0.7069839436992229 -1.116039411797401e-08 -0.0999309077731042 -2.6233 0.7069853570882374 0.7069839804667823 -1.2242708111610129e-08 -0.0999309287547881 -2.6234 0.7069853944919733 0.7069840172347883 -1.3331810432958696e-08 -0.09993094973010257 -2.6235 0.7069854318726693 0.7069840540033137 -1.4427447788539771e-08 -0.09993097069904948 -2.6236 0.7069854692302618 0.7069840907724287 -1.5529365453292865e-08 -0.0999309916616308 -2.6237000000000004 0.7069855065646902 0.7069841275422017 -1.6637307328690176e-08 -0.09993101261784854 -2.6238 0.7069855438758962 0.7069841643126973 -1.775101600692136e-08 -0.09993103356770454 -2.6239 0.7069855811638244 0.7069842010839777 -1.8870232825971e-08 -0.09993105451120075 -2.624 0.7069856184284224 0.706984237856102 -1.999469793163497e-08 -0.09993107544833908 -2.6241000000000003 0.7069856556696404 0.7069842746291268 -2.112415033736839e-08 -0.09993109637912148 -2.6242 0.7069856928874315 0.706984311403106 -2.2258327986735688e-08 -0.09993111730354987 -2.6243000000000003 0.7069857300817519 0.7069843481780906 -2.3396967813258535e-08 -0.09993113822162622 -2.6244 0.7069857672525599 0.7069843849541286 -2.4539805799396464e-08 -0.09993115913335243 -2.6245 0.7069858043998175 0.706984421731265 -2.5686577037695862e-08 -0.09993118003873042 -2.6246000000000005 0.7069858415234889 0.7069844585095422 -2.6837015796709468e-08 -0.09993120093776207 -2.6247000000000003 0.7069858786235417 0.7069844952889996 -2.799085557715804e-08 -0.09993122183044939 -2.6248 0.7069859156999456 0.7069845320696742 -2.9147829177199325e-08 -0.09993124271679422 -2.6249000000000002 0.7069859527526744 0.7069845688515993 -3.030766875401075e-08 -0.0999312635967986 -2.625 0.7069859897817035 0.7069846056348063 -3.1470105883637384e-08 -0.09993128447046438 -2.6251 0.7069860267870118 0.7069846424193225 -3.263487162409248e-08 -0.09993130533779344 -2.6252000000000004 0.706986063768581 0.7069846792051734 -3.380169657542231e-08 -0.09993132619878775 -2.6253 0.706986100726396 0.706984715992381 -3.4970310949528766e-08 -0.09993134705344926 -2.6254 0.706986137660444 0.7069847527809645 -3.6140444622969996e-08 -0.0999313679017798 -2.6255 0.706986174570716 0.7069847895709405 -3.731182720721673e-08 -0.09993138874378142 -2.6256000000000004 0.706986211457205 0.7069848263623222 -3.848418810297079e-08 -0.09993140957945595 -2.6257 0.7069862483199069 0.7069848631551203 -3.9657256572101906e-08 -0.09993143040880532 -2.6258000000000004 0.7069862851588212 0.7069848999493424 -4.08307617921831e-08 -0.09993145123183149 -2.6259 0.7069863219739501 0.7069849367449932 -4.2004432922627e-08 -0.09993147204853631 -2.626 0.7069863587652983 0.7069849735420743 -4.317799916804391e-08 -0.09993149285892172 -2.6261000000000005 0.7069863955328741 0.706985010340585 -4.4351189837629e-08 -0.0999315136629897 -2.6262000000000003 0.7069864322766878 0.7069850471405212 -4.552373441077005e-08 -0.09993153446074216 -2.6263 0.7069864689967532 0.7069850839418758 -4.669536259716651e-08 -0.0999315552521809 -2.6264000000000003 0.7069865056930871 0.7069851207446389 -4.786580439972675e-08 -0.0999315760373079 -2.6265 0.7069865423657089 0.7069851575487981 -4.9034790176828366e-08 -0.09993159681612512 -2.6266000000000003 0.706986579014641 0.7069851943543376 -5.020205070421259e-08 -0.09993161758863446 -2.6267000000000005 0.7069866156399085 0.7069852311612391 -5.136731723743432e-08 -0.09993163835483783 -2.6268000000000002 0.7069866522415398 0.706985267969481 -5.253032157458322e-08 -0.0999316591147371 -2.6269 0.7069866888195653 0.7069853047790392 -5.3690796116131687e-08 -0.09993167986833418 -2.627 0.7069867253740195 0.7069853415898866 -5.484847392543332e-08 -0.099931700615631 -2.6271000000000004 0.706986761904939 0.7069853784019929 -5.600308879442559e-08 -0.0999317213566295 -2.6272 0.7069867984123632 0.7069854152153259 -5.715437530130936e-08 -0.09993174209133156 -2.6273 0.7069868348963348 0.7069854520298495 -5.8302068872348456e-08 -0.09993176281973914 -2.6274 0.7069868713568987 0.7069854888455254 -5.9445905843452315e-08 -0.0999317835418541 -2.6275 0.7069869077941032 0.7069855256623123 -6.058562352067448e-08 -0.09993180425767835 -2.6276 0.7069869442079991 0.7069855624801659 -6.1720960238109e-08 -0.09993182496721381 -2.6277000000000004 0.7069869805986401 0.7069855992990393 -6.285165542012361e-08 -0.09993184567046237 -2.6278 0.7069870169660826 0.7069856361188827 -6.397744964359298e-08 -0.09993186636742594 -2.6279 0.7069870533103858 0.706985672939644 -6.509808468885617e-08 -0.09993188705810647 -2.628 0.7069870896316119 0.7069857097612677 -6.621330361040664e-08 -0.09993190774250588 -2.6281000000000003 0.7069871259298253 0.706985746583696 -6.73228507880666e-08 -0.09993192842062597 -2.6282 0.7069871622050936 0.7069857834068678 -6.842647198683494e-08 -0.0999319490924687 -2.6283000000000003 0.7069871984574871 0.70698582023072 -6.95239144167352e-08 -0.09993196975803599 -2.6284 0.7069872346870785 0.7069858570551864 -7.061492678789305e-08 -0.09993199041732975 -2.6285 0.7069872708939435 0.7069858938801981 -7.169925937168531e-08 -0.09993201107035185 -2.6286000000000005 0.7069873070781603 0.7069859307056838 -7.277666405581737e-08 -0.09993203171710426 -2.6287000000000003 0.7069873432398094 0.7069859675315693 -7.384689440070175e-08 -0.09993205235758879 -2.6288 0.7069873793789745 0.7069860043577779 -7.49097056975713e-08 -0.09993207299180738 -2.6289000000000002 0.7069874154957418 0.7069860411842301 -7.596485502442407e-08 -0.09993209361976196 -2.629 0.7069874515901998 0.7069860780108443 -7.701210129416186e-08 -0.09993211424145441 -2.6291 0.7069874876624398 0.7069861148375358 -7.805120532354548e-08 -0.09993213485688664 -2.6292000000000004 0.7069875237125555 0.7069861516642175 -7.908192987699653e-08 -0.09993215546606055 -2.6293 0.7069875597406432 0.7069861884908 -8.010403972254221e-08 -0.09993217606897802 -2.6294 0.7069875957468017 0.7069862253171906 -8.11173016873265e-08 -0.09993219666564088 -2.6295 0.7069876317311323 0.7069862621432955 -8.212148471485603e-08 -0.09993221725605117 -2.6296000000000004 0.7069876676937387 0.7069862989690174 -8.311635990316396e-08 -0.09993223784021069 -2.6297 0.706987703634727 0.706986335794257 -8.410170057593369e-08 -0.09993225841812135 -2.6298000000000004 0.7069877395542057 0.7069863726189121 -8.507728232586692e-08 -0.09993227898978506 -2.6299 0.7069877754522861 0.7069864094428788 -8.604288305198021e-08 -0.09993229955520375 -2.63 0.706987811329081 0.7069864462660502 -8.699828303940227e-08 -0.0999323201143792 -2.6301000000000005 0.7069878471847062 0.7069864830883179 -8.794326498366006e-08 -0.09993234066731345 -2.6302000000000003 0.7069878830192797 0.7069865199095703 -8.887761405139416e-08 -0.0999323612140083 -2.6303 0.7069879188329218 0.7069865567296938 -8.980111792632889e-08 -0.09993238175446567 -2.6304000000000003 0.7069879546257547 0.7069865935485731 -9.071356685697723e-08 -0.09993240228868745 -2.6305 0.7069879903979033 0.7069866303660898 -9.161475371128464e-08 -0.09993242281667554 -2.6306000000000003 0.7069880261494941 0.7069866671821237 -9.250447401305817e-08 -0.0999324433384318 -2.6307000000000005 0.7069880618806565 0.7069867039965527 -9.338252599661034e-08 -0.09993246385395817 -2.6308000000000002 0.7069880975915215 0.7069867408092525 -9.424871064665774e-08 -0.09993248436325652 -2.6309 0.7069881332822223 0.7069867776200963 -9.510283174515854e-08 -0.09993250486632872 -2.631 0.7069881689528945 0.7069868144289552 -9.594469591901744e-08 -0.09993252536317668 -2.6311000000000004 0.7069882046036753 0.7069868512356989 -9.677411267738217e-08 -0.09993254585380229 -2.6312 0.7069882402347036 0.7069868880401945 -9.759089446541996e-08 -0.09993256633820738 -2.6313 0.7069882758461215 0.7069869248423074 -9.839485669554254e-08 -0.09993258681639389 -2.6314 0.7069883114380717 0.7069869616419011 -9.918581778730479e-08 -0.09993260728836373 -2.6315 0.7069883470106999 0.7069869984388368 -9.996359922465059e-08 -0.09993262775411874 -2.6316 0.7069883825641528 0.7069870352329746 -1.00728025580199e-07 -0.09993264821366085 -2.6317000000000004 0.7069884180985797 0.7069870720241715 -1.0147892456381646e-07 -0.09993266866699191 -2.6318 0.7069884536141309 0.7069871088122839 -1.0221612705644395e-07 -0.09993268911411374 -2.6319 0.7069884891109592 0.7069871455971658 -1.0293946714912822e-07 -0.09993270955502837 -2.632 0.7069885245892189 0.7069871823786698 -1.0364878218205309e-07 -0.0999327299897376 -2.6321000000000003 0.7069885600490657 0.7069872191566464 -1.0434391278183602e-07 -0.09993275041824332 -2.6322 0.7069885954906575 0.7069872559309448 -1.0502470289275312e-07 -0.09993277084054741 -2.6323000000000003 0.7069886309141533 0.7069872927014123 -1.0569099981490304e-07 -0.09993279125665173 -2.6324 0.706988666319714 0.7069873294678944 -1.0634265423456468e-07 -0.09993281166655817 -2.6325 0.7069887017075024 0.7069873662302357 -1.0697952027363677e-07 -0.09993283207026865 -2.6326000000000005 0.7069887370776822 0.7069874029882788 -1.0760145549570943e-07 -0.09993285246778502 -2.6327000000000003 0.7069887724304187 0.7069874397418652 -1.0820832095637112e-07 -0.0999328728591092 -2.6328 0.7069888077658788 0.7069874764908344 -1.0879998123096424e-07 -0.09993289324424304 -2.6329000000000002 0.706988843084231 0.7069875132350245 -1.0937630444927959e-07 -0.09993291362318837 -2.633 0.7069888783856446 0.7069875499742728 -1.0993716230423001e-07 -0.09993293399594713 -2.6331 0.7069889136702909 0.706987586708415 -1.1048243010736147e-07 -0.09993295436252116 -2.6332000000000004 0.7069889489383423 0.7069876234372854 -1.1101198680099622e-07 -0.09993297472291235 -2.6333 0.7069889841899719 0.7069876601607169 -1.1152571498772301e-07 -0.09993299507712261 -2.6334 0.7069890194253549 0.7069876968785416 -1.1202350096162217e-07 -0.09993301542515376 -2.6335 0.7069890546446669 0.7069877335905903 -1.1250523471867391e-07 -0.0999330357670077 -2.6336000000000004 0.7069890898480848 0.7069877702966922 -1.1297081000359588e-07 -0.0999330561026863 -2.6337 0.7069891250357875 0.706987806996676 -1.1342012431331261e-07 -0.09993307643219144 -2.6338000000000004 0.7069891602079533 0.7069878436903692 -1.1385307892991525e-07 -0.09993309675552497 -2.6339 0.706989195364763 0.7069878803775982 -1.1426957893106993e-07 -0.09993311707268882 -2.634 0.7069892305063976 0.7069879170581883 -1.1466953323165108e-07 -0.09993313738368478 -2.6341000000000006 0.7069892656330392 0.706987953731964 -1.1505285458374148e-07 -0.09993315768851477 -2.6342000000000003 0.7069893007448709 0.706987990398749 -1.1541945960612254e-07 -0.09993317798718067 -2.6343 0.7069893358420765 0.7069880270583659 -1.157692687998868e-07 -0.09993319827968432 -2.6344000000000003 0.7069893709248407 0.7069880637106369 -1.1610220655711156e-07 -0.0999332185660276 -2.6345 0.7069894059933488 0.7069881003553831 -1.1641820119034918e-07 -0.09993323884621239 -2.6346000000000003 0.706989441047787 0.7069881369924249 -1.1671718494130068e-07 -0.09993325912024056 -2.6347000000000005 0.7069894760883422 0.7069881736215822 -1.1699909400510189e-07 -0.09993327938811392 -2.6348000000000003 0.7069895111152018 0.7069882102426739 -1.1726386851818038e-07 -0.09993329964983443 -2.6349 0.7069895461285538 0.7069882468555189 -1.1751145260162355e-07 -0.0999333199054039 -2.635 0.7069895811285869 0.7069882834599348 -1.1774179434730081e-07 -0.09993334015482418 -2.6351000000000004 0.70698961611549 0.7069883200557395 -1.1795484585776228e-07 -0.09993336039809719 -2.6352 0.7069896510894533 0.70698835664275 -1.1815056322195261e-07 -0.0999333806352248 -2.6353 0.7069896860506658 0.7069883932207826 -1.1832890654643602e-07 -0.09993340086620879 -2.6354 0.7069897209993186 0.7069884297896537 -1.1848983995886575e-07 -0.0999334210910511 -2.6355 0.7069897559356018 0.7069884663491792 -1.1863333161665768e-07 -0.09993344130975354 -2.6356 0.7069897908597067 0.7069885028991747 -1.1875935371045976e-07 -0.09993346152231797 -2.6357000000000004 0.7069898257718247 0.7069885394394557 -1.1886788245894786e-07 -0.09993348172874633 -2.6358 0.7069898606721472 0.7069885759698373 -1.1895889812790772e-07 -0.09993350192904045 -2.6359 0.7069898955608658 0.7069886124901341 -1.1903238503890856e-07 -0.09993352212320217 -2.636 0.7069899304381722 0.7069886490001613 -1.1908833155195586e-07 -0.09993354231123334 -2.6361000000000003 0.7069899653042578 0.7069886854997337 -1.1912673008457331e-07 -0.09993356249313584 -2.6362 0.7069900001593149 0.7069887219886659 -1.1914757709619028e-07 -0.0999335826689115 -2.6363000000000003 0.7069900350035354 0.7069887584667729 -1.1915087309855021e-07 -0.09993360283856226 -2.6364 0.7069900698371107 0.7069887949338691 -1.1913662265571057e-07 -0.0999336230020899 -2.6365 0.7069901046602326 0.7069888313897701 -1.1910483437883868e-07 -0.09993364315949632 -2.6366000000000005 0.7069901394730926 0.7069888678342904 -1.1905552091753813e-07 -0.09993366331078338 -2.6367000000000003 0.706990174275882 0.7069889042672451 -1.1898869896505293e-07 -0.09993368345595285 -2.6368 0.706990209068792 0.7069889406884502 -1.1890438923745084e-07 -0.0999337035950067 -2.6369000000000002 0.7069902438520133 0.7069889770977211 -1.1880261649097057e-07 -0.09993372372794673 -2.637 0.7069902786257364 0.706989013494874 -1.186834094977357e-07 -0.09993374385477477 -2.6371 0.7069903133901514 0.7069890498797253 -1.1854680103881576e-07 -0.09993376397549272 -2.6372000000000004 0.7069903481454483 0.706989086252092 -1.1839282791116512e-07 -0.09993378409010245 -2.6373 0.706990382891816 0.7069891226117909 -1.1822153089986742e-07 -0.09993380419860576 -2.6374 0.7069904176294436 0.70698915895864 -1.1803295477466613e-07 -0.09993382430100449 -2.6375 0.7069904523585192 0.7069891952924576 -1.1782714827435203e-07 -0.09993384439730055 -2.6376000000000004 0.7069904870792305 0.7069892316130628 -1.1760416410155905e-07 -0.09993386448749575 -2.6377 0.7069905217917647 0.7069892679202747 -1.1736405891062118e-07 -0.099933884571592 -2.6378000000000004 0.7069905564963084 0.7069893042139135 -1.1710689327287804e-07 -0.09993390464959108 -2.6379 0.706990591193047 0.7069893404937999 -1.1683273169402209e-07 -0.09993392472149487 -2.638 0.7069906258821654 0.7069893767597555 -1.1654164257419997e-07 -0.09993394478730518 -2.6381000000000006 0.7069906605638481 0.7069894130116031 -1.1623369818546114e-07 -0.09993396484702394 -2.6382000000000003 0.7069906952382783 0.7069894492491655 -1.1590897468390093e-07 -0.09993398490065294 -2.6383 0.7069907299056385 0.7069894854722669 -1.1556755206802716e-07 -0.09993400494819407 -2.6384000000000003 0.7069907645661104 0.7069895216807319 -1.1520951416488234e-07 -0.09993402498964915 -2.6385 0.7069907992198747 0.7069895578743866 -1.148349486126965e-07 -0.09993404502502 -2.6386000000000003 0.7069908338671109 0.7069895940530577 -1.1444394682272319e-07 -0.09993406505430848 -2.6387000000000005 0.7069908685079977 0.7069896302165734 -1.1403660397577009e-07 -0.09993408507751646 -2.6388000000000003 0.7069909031427131 0.7069896663647625 -1.1361301899617815e-07 -0.09993410509464581 -2.6389 0.7069909377714327 0.706989702497455 -1.1317329453273961e-07 -0.09993412510569832 -2.639 0.7069909723943324 0.7069897386144823 -1.127175369135952e-07 -0.09993414511067583 -2.6391000000000004 0.7069910070115859 0.7069897747156765 -1.122458561340911e-07 -0.0999341651095802 -2.6392 0.7069910416233665 0.7069898108008716 -1.1175836584290111e-07 -0.09993418510241328 -2.6393 0.7069910762298455 0.7069898468699024 -1.1125518327957662e-07 -0.09993420508917693 -2.6394 0.7069911108311935 0.7069898829226049 -1.107364292866897e-07 -0.09993422506987293 -2.6395 0.7069911454275792 0.706989918958817 -1.1020222825432191e-07 -0.09993424504450323 -2.6396 0.7069911800191704 0.7069899549783771 -1.0965270809924765e-07 -0.09993426501306953 -2.6397000000000004 0.706991214606133 0.7069899909811258 -1.090880002389133e-07 -0.09993428497557372 -2.6398 0.706991249188632 0.7069900269669049 -1.0850823954459965e-07 -0.09993430493201766 -2.6399 0.7069912837668303 0.7069900629355578 -1.079135643292789e-07 -0.09993432488240316 -2.64 0.70699131834089 0.7069900988869293 -1.0730411629470554e-07 -0.09993434482673214 -2.6401000000000003 0.706991352910971 0.7069901348208657 -1.0668004051233443e-07 -0.09993436476500639 -2.6402 0.7069913874772319 0.7069901707372148 -1.0604148538428948e-07 -0.0999343846972277 -2.6403000000000003 0.7069914220398296 0.7069902066358267 -1.0538860261040395e-07 -0.09993440462339798 -2.6404 0.706991456598919 0.7069902425165521 -1.0472154714658705e-07 -0.09993442454351899 -2.6405 0.706991491154654 0.7069902783792443 -1.0404047717273157e-07 -0.09993444445759263 -2.6406000000000005 0.7069915257071864 0.7069903142237579 -1.0334555405021317e-07 -0.0999344643656207 -2.6407000000000003 0.7069915602566659 0.7069903500499495 -1.0263694229066533e-07 -0.09993448426760507 -2.6408 0.7069915948032408 0.7069903858576772 -1.0191480951261128e-07 -0.0999345041635475 -2.6409000000000002 0.7069916293470577 0.7069904216468013 -1.0117932640156535e-07 -0.09993452405344992 -2.641 0.7069916638882607 0.7069904574171836 -1.0043066667707323e-07 -0.09993454393731405 -2.6411000000000002 0.7069916984269927 0.7069904931686883 -9.966900703633347e-08 -0.09993456381514182 -2.6412000000000004 0.7069917329633941 0.7069905289011811 -9.889452712644187e-08 -0.09993458368693503 -2.6413 0.7069917674976041 0.7069905646145296 -9.810740949842134e-08 -0.09993460355269554 -2.6414 0.7069918020297588 0.706990600308604 -9.73078395638538e-08 -0.09993462341242514 -2.6415 0.706991836559993 0.7069906359832757 -9.649600555064475e-08 -0.09993464326612565 -2.6416000000000004 0.7069918710884393 0.7069906716384187 -9.567209845792041e-08 -0.0999346631137989 -2.6417 0.7069919056152282 0.7069907072739092 -9.483631201179232e-08 -0.09993468295544675 -2.6418000000000004 0.7069919401404883 0.706990742889625 -9.398884261678508e-08 -0.09993470279107101 -2.6419 0.7069919746643456 0.7069907784854464 -9.312988931680505e-08 -0.09993472262067353 -2.642 0.7069920091869243 0.706990814061256 -9.225965374483336e-08 -0.09993474244425612 -2.6421000000000006 0.7069920437083461 0.7069908496169379 -9.137834007782314e-08 -0.09993476226182058 -2.6422000000000003 0.7069920782287309 0.7069908851523793 -9.048615497945361e-08 -0.09993478207336876 -2.6423 0.7069921127481961 0.7069909206674689 -8.958330756543564e-08 -0.09993480187890247 -2.6424000000000003 0.7069921472668567 0.7069909561620986 -8.86700093427964e-08 -0.09993482167842359 -2.6425 0.7069921817848255 0.7069909916361616 -8.774647416651127e-08 -0.09993484147193392 -2.6426000000000003 0.7069922163022132 0.706991027089554 -8.681291819093162e-08 -0.09993486125943524 -2.6427000000000005 0.7069922508191278 0.7069910625221737 -8.586955980993682e-08 -0.09993488104092939 -2.6428000000000003 0.7069922853356749 0.7069910979339218 -8.491661962310715e-08 -0.0999349008164182 -2.6429 0.7069923198519583 0.7069911333247013 -8.395432036633482e-08 -0.09993492058590348 -2.643 0.7069923543680785 0.7069911686944177 -8.298288686672123e-08 -0.09993494034938709 -2.6431000000000004 0.7069923888841342 0.706991204042979 -8.200254599313728e-08 -0.09993496010687081 -2.6432 0.7069924234002216 0.7069912393702955 -8.101352659637545e-08 -0.09993497985835649 -2.6433 0.7069924579164342 0.7069912746762798 -8.001605946664908e-08 -0.09993499960384594 -2.6434 0.7069924924328632 0.7069913099608476 -7.901037726940757e-08 -0.09993501934334101 -2.6435 0.7069925269495968 0.7069913452239167 -7.799671449589679e-08 -0.09993503907684344 -2.6436 0.7069925614667212 0.7069913804654073 -7.69753074033111e-08 -0.09993505880435509 -2.6437000000000004 0.7069925959843198 0.706991415685243 -7.594639396361902e-08 -0.09993507852587784 -2.6438 0.7069926305024736 0.7069914508833488 -7.491021381282256e-08 -0.09993509824141339 -2.6439 0.7069926650212606 0.706991486059653 -7.386700819110928e-08 -0.0999351179509636 -2.644 0.7069926995407566 0.7069915212140863 -7.281701988213693e-08 -0.09993513765453031 -2.6441000000000003 0.7069927340610347 0.7069915563465823 -7.176049316272651e-08 -0.09993515735211532 -2.6442 0.7069927685821652 0.706991591457077 -7.069767374388164e-08 -0.09993517704372047 -2.6443000000000003 0.7069928031042159 0.706991626545509 -6.962880871441007e-08 -0.09993519672934757 -2.6444 0.7069928376272517 0.7069916616118195 -6.855414648020836e-08 -0.09993521640899837 -2.6445 0.7069928721513354 0.7069916966559526 -6.747393671308749e-08 -0.09993523608267477 -2.6446000000000005 0.7069929066765261 0.7069917316778556 -6.638843028702185e-08 -0.09993525575037854 -2.6447000000000003 0.706992941202881 0.7069917666774772 -6.529787921916858e-08 -0.09993527541211146 -2.6448 0.7069929757304545 0.7069918016547698 -6.420253661825956e-08 -0.09993529506787541 -2.6449000000000003 0.7069930102592981 0.7069918366096883 -6.310265662085035e-08 -0.09993531471767217 -2.645 0.7069930447894603 0.7069918715421907 -6.199849432887011e-08 -0.09993533436150355 -2.6451000000000002 0.7069930793209875 0.706991906452237 -6.089030576148305e-08 -0.09993535399937138 -2.6452000000000004 0.7069931138539225 0.7069919413397903 -5.977834778569946e-08 -0.09993537363127739 -2.6453 0.7069931483883062 0.7069919762048167 -5.866287805956355e-08 -0.0999353932572235 -2.6454 0.706993182924176 0.7069920110472849 -5.7544154974040196e-08 -0.09993541287721147 -2.6455 0.7069932174615668 0.7069920458671659 -5.6422437591432256e-08 -0.09993543249124302 -2.6456000000000004 0.706993252000511 0.7069920806644345 -5.529798558770102e-08 -0.09993545209932006 -2.6457 0.706993286541038 0.7069921154390678 -5.41710591891488e-08 -0.09993547170144444 -2.6458000000000004 0.706993321083174 0.7069921501910452 -5.304191911690778e-08 -0.09993549129761783 -2.6459 0.706993355626943 0.70699218492035 -5.1910826521020526e-08 -0.0999355108878422 -2.646 0.7069933901723658 0.7069922196269669 -5.077804292276042e-08 -0.09993553047211921 -2.6461000000000006 0.7069934247194605 0.7069922543108847 -4.964383015662686e-08 -0.0999355500504507 -2.6462000000000003 0.7069934592682423 0.7069922889720945 -4.850845030431733e-08 -0.09993556962283852 -2.6463 0.7069934938187239 0.7069923236105897 -4.737216563997521e-08 -0.09993558918928441 -2.6464000000000003 0.7069935283709148 0.7069923582263677 -4.6235238565408687e-08 -0.09993560874979024 -2.6465 0.7069935629248216 0.7069923928194276 -4.509793155203171e-08 -0.09993562830435775 -2.6466000000000003 0.7069935974804487 0.706992427389772 -4.396050707949819e-08 -0.09993564785298875 -2.6467 0.706993632037797 0.706992461937406 -4.282322757276401e-08 -0.0999356673956851 -2.6468000000000003 0.7069936665968652 0.7069924964623375 -4.168635534668435e-08 -0.09993568693244854 -2.6469 0.7069937011576487 0.7069925309645775 -4.055015254050072e-08 -0.09993570646328093 -2.647 0.7069937357201399 0.7069925654441397 -3.9414881061869064e-08 -0.09993572598818401 -2.6471000000000005 0.7069937702843292 0.7069925999010404 -3.828080252202444e-08 -0.09993574550715961 -2.6472 0.7069938048502036 0.7069926343352986 -3.714817817810148e-08 -0.09993576502020951 -2.6473 0.7069938394177468 0.7069926687469366 -3.601726887331354e-08 -0.09993578452733547 -2.6474 0.706993873986941 0.7069927031359792 -3.4888334975668144e-08 -0.09993580402853931 -2.6475 0.7069939085577652 0.7069927375024543 -3.3761636318878005e-08 -0.09993582352382294 -2.6476 0.7069939431301948 0.7069927718463921 -3.263743214316356e-08 -0.09993584301318807 -2.6477000000000004 0.7069939777042029 0.7069928061678256 -3.151598103150188e-08 -0.09993586249663644 -2.6478 0.7069940122797602 0.7069928404667909 -3.039754085487449e-08 -0.09993588197416992 -2.6479 0.7069940468568343 0.7069928747433265 -2.9282368714045673e-08 -0.09993590144579023 -2.648 0.7069940814353899 0.7069929089974741 -2.8170720875377725e-08 -0.09993592091149925 -2.6481000000000003 0.7069941160153892 0.7069929432292782 -2.706285271510296e-08 -0.09993594037129877 -2.6482 0.7069941505967918 0.7069929774387851 -2.5959018661210476e-08 -0.09993595982519052 -2.6483000000000003 0.7069941851795544 0.706993011626045 -2.485947213229714e-08 -0.09993597927317635 -2.6484 0.7069942197636306 0.70699304579111 -2.3764465480104885e-08 -0.09993599871525803 -2.6485 0.706994254348972 0.7069930799340349 -2.267424993466008e-08 -0.09993601815143728 -2.6486000000000005 0.7069942889355271 0.7069931140548779 -2.15890755446424e-08 -0.09993603758171599 -2.6487000000000003 0.7069943235232418 0.7069931481536992 -2.0509191119705283e-08 -0.09993605700609592 -2.6488 0.7069943581120594 0.706993182230562 -1.943484417453109e-08 -0.09993607642457886 -2.6489000000000003 0.7069943927019208 0.7069932162855318 -1.8366280867248425e-08 -0.09993609583716666 -2.649 0.7069944272927636 0.7069932503186769 -1.7303745951293553e-08 -0.09993611524386099 -2.6491000000000002 0.7069944618845232 0.7069932843300686 -1.624748271469509e-08 -0.0999361346446637 -2.6492000000000004 0.7069944964771325 0.7069933183197801 -1.5197732924996515e-08 -0.09993615403957656 -2.6493 0.7069945310705217 0.7069933522878874 -1.4154736770709275e-08 -0.09993617342860134 -2.6494 0.7069945656646186 0.7069933862344697 -1.3118732816209955e-08 -0.09993619281173989 -2.6495 0.7069946002593481 0.7069934201596078 -1.2089957932351347e-08 -0.099936212188994 -2.6496000000000004 0.706994634854633 0.7069934540633854 -1.1068647256130132e-08 -0.09993623156036535 -2.6497 0.706994669450393 0.706993487945889 -1.0055034127803147e-08 -0.09993625092585584 -2.6498000000000004 0.7069947040465461 0.706993521807207 -9.04935004448354e-09 -0.09993627028546714 -2.6499 0.706994738643007 0.7069935556474307 -8.051824602027524e-09 -0.09993628963920112 -2.65 0.7069947732396888 0.7069935894666541 -7.062685447763173e-09 -0.09993630898705957 -2.6501000000000006 0.7069948078365016 0.7069936232649727 -6.082158221509815e-09 -0.0999363283290442 -2.6502000000000003 0.7069948424333534 0.7069936570424853 -5.1104665074394595e-09 -0.09993634766515691 -2.6503 0.7069948770301497 0.7069936907992922 -4.147831786371903e-09 -0.09993636699539934 -2.6504000000000003 0.7069949116267932 0.7069937245354972 -3.194473380263574e-09 -0.09993638631977336 -2.6505 0.7069949462231853 0.7069937582512055 -2.250608407104726e-09 -0.09993640563828074 -2.6506000000000003 0.706994980819224 0.7069937919465248 -1.3164517288777322e-09 -0.09993642495092321 -2.6507 0.7069950154148059 0.7069938256215652 -3.922159029848271e-10 -0.09993644425770264 -2.6508000000000003 0.7069950500098249 0.7069938592764393 5.218888697935964e-10 -0.09993646355862074 -2.6509 0.7069950846041724 0.7069938929112614 1.4256547851976276e-09 -0.09993648285367927 -2.651 0.7069951191977384 0.7069939265261482 2.3188764918663507e-09 -0.09993650214288007 -2.6511000000000005 0.70699515379041 0.7069939601212187 3.201351125164953e-09 -0.09993652142622489 -2.6512000000000002 0.7069951883820722 0.706993993696594 4.072878369634769e-09 -0.09993654070371544 -2.6513 0.7069952229726089 0.7069940272523974 4.933260491953029e-09 -0.09993655997535365 -2.6514 0.7069952575619001 0.7069940607887542 5.78230238863775e-09 -0.09993657924114117 -2.6515 0.7069952921498255 0.7069940943057913 6.619811634619999e-09 -0.09993659850107983 -2.6516 0.7069953267362619 0.7069941278036387 7.445598523142527e-09 -0.09993661775517143 -2.6517000000000004 0.7069953613210835 0.7069941612824273 8.259476104791053e-09 -0.09993663700341765 -2.6518 0.7069953959041639 0.7069941947422906 9.061260240403324e-09 -0.09993665624582032 -2.6519 0.706995430485374 0.7069942281833639 9.850769628824696e-09 -0.09993667548238118 -2.652 0.7069954650645828 0.7069942616057845 1.0627825865021368e-08 -0.09993669471310207 -2.6521000000000003 0.7069954996416575 0.7069942950096914 1.1392253467835955e-08 -0.09993671393798476 -2.6522 0.7069955342164636 0.7069943283952254 1.2143879916416689e-08 -0.09993673315703094 -2.6523000000000003 0.7069955687888639 0.7069943617625293 1.2882535703126474e-08 -0.0999367523702424 -2.6524 0.706995603358721 0.7069943951117479 1.360805436043111e-08 -0.09993677157762096 -2.6525 0.7069956379258945 0.706994428443027 1.4320272499063202e-08 -0.09993679077916834 -2.6526000000000005 0.7069956724902428 0.706994461756515 1.5019029848788168e-08 -0.09993680997488637 -2.6527000000000003 0.7069957070516224 0.7069944950523614 1.5704169298302872e-08 -0.09993682916477677 -2.6528 0.7069957416098882 0.7069945283307175 1.6375536921256484e-08 -0.09993684834884133 -2.6529000000000003 0.7069957761648936 0.7069945615917365 1.7032982018751197e-08 -0.0999368675270818 -2.653 0.7069958107164904 0.7069945948355725 1.7676357146230448e-08 -0.09993688669949996 -2.6531000000000002 0.7069958452645284 0.7069946280623818 1.830551814643866e-08 -0.09993690586609756 -2.6532000000000004 0.7069958798088569 0.706994661272322 1.8920324187585158e-08 -0.0999369250268764 -2.6533 0.7069959143493226 0.706994694465552 1.9520637793701834e-08 -0.09993694418183822 -2.6534 0.7069959488857717 0.7069947276422321 2.010632487326608e-08 -0.09993696333098478 -2.6535 0.7069959834180484 0.7069947608025247 2.067725474955845e-08 -0.09993698247431788 -2.6536000000000004 0.7069960179459955 0.7069947939465921 2.1233300191887683e-08 -0.09993700161183922 -2.6537 0.7069960524694552 0.7069948270745997 2.1774337435540025e-08 -0.0999370207435506 -2.6538000000000004 0.7069960869882674 0.7069948601867131 2.230024621907578e-08 -0.09993703986945379 -2.6539 0.7069961215022715 0.7069948932830992 2.2810909808615443e-08 -0.09993705898955055 -2.654 0.7069961560113054 0.7069949263639262 2.330621501692165e-08 -0.09993707810384261 -2.6541000000000006 0.7069961905152058 0.7069949594293639 2.378605224936936e-08 -0.09993709721233177 -2.6542000000000003 0.7069962250138087 0.7069949924795824 2.4250315500476405e-08 -0.09993711631501977 -2.6543 0.7069962595069484 0.7069950255147539 2.4698902385128507e-08 -0.09993713541190836 -2.6544 0.7069962939944585 0.7069950585350508 2.5131714176743203e-08 -0.09993715450299934 -2.6545 0.7069963284761713 0.7069950915406471 2.5548655810739285e-08 -0.09993717358829447 -2.6546000000000003 0.7069963629519185 0.7069951245317172 2.5949635914027103e-08 -0.09993719266779544 -2.6547 0.7069963974215303 0.7069951575084368 2.6334566829294692e-08 -0.09993721174150406 -2.6548000000000003 0.706996431884837 0.7069951904709827 2.6703364616742498e-08 -0.0999372308094221 -2.6549 0.7069964663416668 0.706995223419532 2.7055949095716736e-08 -0.09993724987155127 -2.655 0.7069965007918481 0.7069952563542632 2.7392243844709396e-08 -0.09993726892789334 -2.6551000000000005 0.7069965352352079 0.7069952892753553 2.77121762204402e-08 -0.09993728797845014 -2.6552000000000002 0.7069965696715729 0.7069953221829877 2.801567737520383e-08 -0.09993730702322334 -2.6553 0.7069966041007689 0.7069953550773412 2.830268227768662e-08 -0.09993732606221478 -2.6554 0.7069966385226207 0.7069953879585964 2.857312972857906e-08 -0.09993734509542605 -2.6555 0.7069966729369532 0.7069954208269351 2.8826962355371633e-08 -0.09993736412285906 -2.6556 0.7069967073435901 0.7069954536825398 2.9064126629702036e-08 -0.0999373831445155 -2.6557000000000004 0.706996741742355 0.706995486525593 2.928457290898856e-08 -0.09993740216039709 -2.6558 0.706996776133071 0.7069955193562782 2.948825539826616e-08 -0.09993742117050569 -2.6559 0.7069968105155603 0.7069955521747788 2.9675132197024e-08 -0.09993744017484296 -2.656 0.7069968448896451 0.7069955849812792 2.9845165288797104e-08 -0.0999374591734107 -2.6561000000000003 0.7069968792551473 0.7069956177759635 2.9998320555044145e-08 -0.09993747816621061 -2.6562 0.706996913611888 0.7069956505590167 3.0134567783821065e-08 -0.09993749715324446 -2.6563000000000003 0.7069969479596887 0.7069956833306238 3.025388067325052e-08 -0.09993751613451403 -2.6564 0.7069969822983704 0.70699571609097 3.035623682631772e-08 -0.09993753511002104 -2.6565 0.7069970166277534 0.706995748840241 3.044161777689125e-08 -0.09993755407976729 -2.6566000000000005 0.7069970509476585 0.7069957815786221 3.0510008975845326e-08 -0.09993757304375445 -2.6567000000000003 0.7069970852579059 0.7069958143062991 3.056139979452921e-08 -0.09993759200198427 -2.6568 0.7069971195583165 0.7069958470234579 3.059578353517556e-08 -0.09993761095445854 -2.6569000000000003 0.7069971538487103 0.706995879730284 3.0613157423961534e-08 -0.09993762990117899 -2.657 0.7069971881289077 0.7069959124269635 3.061352260927408e-08 -0.09993764884214731 -2.6571000000000002 0.7069972223987293 0.706995945113682 3.0596884161709914e-08 -0.09993766777736537 -2.6572000000000005 0.7069972566579955 0.7069959777906254 3.056325107407554e-08 -0.09993768670683484 -2.6573 0.7069972909065271 0.7069960104579789 3.05126362665914e-08 -0.09993770563055746 -2.6574 0.706997325144145 0.7069960431159277 3.044505655393215e-08 -0.099937724548535 -2.6575 0.7069973593706704 0.706996075764657 3.036053268339056e-08 -0.09993774346076917 -2.6576000000000004 0.7069973935859246 0.7069961084043515 3.025908928283583e-08 -0.09993776236726176 -2.6577 0.7069974277897291 0.7069961410351958 3.01407548867344e-08 -0.09993778126801445 -2.6578000000000004 0.7069974619819062 0.706996173657374 3.0005561911863876e-08 -0.09993780016302906 -2.6579 0.7069974961622782 0.70699620627107 2.985354666078244e-08 -0.0999378190523073 -2.658 0.7069975303306681 0.7069962388764663 2.9684749304481617e-08 -0.09993783793585084 -2.6581000000000006 0.7069975644868992 0.7069962714737466 2.949921386850851e-08 -0.09993785681366149 -2.6582000000000003 0.7069975986307955 0.7069963040630924 2.929698823296578e-08 -0.09993787568574099 -2.6583 0.7069976327621811 0.7069963366446861 2.9078124113429693e-08 -0.09993789455209103 -2.6584 0.7069976668808814 0.7069963692187087 2.8842677034929265e-08 -0.09993791341271345 -2.6585 0.7069977009867219 0.7069964017853405 2.8590706345824057e-08 -0.09993793226760989 -2.6586000000000003 0.7069977350795291 0.706996434344761 2.832227518657915e-08 -0.09993795111678214 -2.6587 0.70699776915913 0.7069964668971496 2.8037450468948455e-08 -0.0999379699602319 -2.6588000000000003 0.7069978032253523 0.7069964994426844 2.7736302870770557e-08 -0.09993798879796087 -2.6589 0.7069978372780248 0.706996531981543 2.7418906822090916e-08 -0.09993800762997085 -2.659 0.7069978713169772 0.706996564513902 2.708534046005906e-08 -0.09993802645626361 -2.6591000000000005 0.7069979053420397 0.7069965970399374 2.6735685637602202e-08 -0.09993804527684083 -2.6592000000000002 0.7069979393530436 0.7069966295598238 2.6370027900873838e-08 -0.09993806409170425 -2.6593 0.7069979733498211 0.7069966620737347 2.598845645282455e-08 -0.09993808290085557 -2.6594 0.7069980073322056 0.7069966945818436 2.5591064149732556e-08 -0.09993810170429661 -2.6595 0.7069980413000314 0.7069967270843218 2.5177947461305084e-08 -0.09993812050202898 -2.6596 0.706998075253134 0.7069967595813401 2.4749206455065842e-08 -0.09993813929405448 -2.6597000000000004 0.70699810919135 0.7069967920730685 2.4304944779007798e-08 -0.09993815808037493 -2.6598 0.7069981431145167 0.7069968245596752 2.3845269618225085e-08 -0.09993817686099193 -2.6599 0.7069981770224733 0.7069968570413272 2.337029169838245e-08 -0.09993819563590725 -2.66 0.7069982109150599 0.7069968895181908 2.2880125230204107e-08 -0.09993821440512263 -2.6601000000000004 0.7069982447921175 0.7069969219904306 2.2374887897330664e-08 -0.09993823316863977 -2.6602 0.7069982786534892 0.7069969544582101 2.185470082596147e-08 -0.09993825192646044 -2.6603000000000003 0.7069983124990189 0.7069969869216914 2.1319688546690696e-08 -0.09993827067858635 -2.6604 0.706998346328552 0.7069970193810353 2.076997897282329e-08 -0.09993828942501926 -2.6605 0.7069983801419353 0.706997051836401 2.0205703382160378e-08 -0.09993830816576083 -2.6606000000000005 0.7069984139390169 0.7069970842879465 1.962699636409021e-08 -0.09993832690081285 -2.6607000000000003 0.7069984477196467 0.706997116735828 1.903399579703674e-08 -0.099938345630177 -2.6608 0.7069984814836761 0.7069971491802001 1.842684281636725e-08 -0.099938364353855 -2.6609000000000003 0.7069985152309577 0.7069971816212163 1.7805681777963156e-08 -0.0999383830718486 -2.661 0.706998548961346 0.7069972140590284 1.7170660217454004e-08 -0.09993840178415954 -2.6611000000000002 0.706998582674697 0.7069972464937866 1.6521928840676492e-08 -0.09993842049078955 -2.6612000000000005 0.7069986163708686 0.7069972789256389 1.5859641458622342e-08 -0.09993843919174034 -2.6613 0.7069986500497201 0.7069973113547323 1.5183954966621616e-08 -0.09993845788701362 -2.6614 0.7069986837111124 0.7069973437812116 1.4495029303576712e-08 -0.09993847657661112 -2.6615 0.7069987173549085 0.7069973762052202 1.379302741206373e-08 -0.09993849526053454 -2.6616000000000004 0.706998750980973 0.7069974086268991 1.3078115202770635e-08 -0.09993851393878557 -2.6617 0.7069987845891725 0.7069974410463884 1.2350461513731259e-08 -0.09993853261136605 -2.6618000000000004 0.7069988181793753 0.7069974734638259 1.161023807563083e-08 -0.09993855127827764 -2.6619 0.7069988517514515 0.7069975058793472 1.0857619459764267e-08 -0.09993856993952205 -2.662 0.7069988853052733 0.7069975382930866 1.009278304681116e-08 -0.099938588595101 -2.6621000000000006 0.7069989188407144 0.7069975707051759 9.31590898346768e-09 -0.0999386072450162 -2.6622000000000003 0.7069989523576514 0.7069976031157452 8.527180140813218e-09 -0.0999386258892694 -2.6623 0.706998985855962 0.7069976355249226 7.726782064870763e-09 -0.09993864452786233 -2.6624 0.7069990193355261 0.7069976679328343 6.914902937575629e-09 -0.09993866316079664 -2.6625 0.706999052796226 0.7069977003396039 6.091733536009447e-09 -0.0999386817880741 -2.6626000000000003 0.7069990862379456 0.7069977327453534 5.257467181225828e-09 -0.09993870040969637 -2.6627 0.7069991196605715 0.706997765150203 4.412299698351718e-09 -0.09993871902566522 -2.6628000000000003 0.7069991530639919 0.7069977975542698 3.5564293654130608e-09 -0.09993873763598232 -2.6629 0.7069991864480971 0.7069978299576696 2.690056867364621e-09 -0.0999387562406494 -2.663 0.7069992198127805 0.706997862360516 1.8133852535892614e-09 -0.09993877483966826 -2.6631000000000005 0.7069992531579364 0.7069978947629197 9.266198875909626e-10 -0.09993879343304049 -2.6632000000000002 0.7069992864834627 0.7069979271649898 2.9968402759372736e-11 -0.0999388120207679 -2.6633 0.7069993197892582 0.7069979595668328 -8.763593531413427e-10 -0.09993883060285215 -2.6634 0.7069993530752249 0.706997991968553 -1.7921513630753116e-09 -0.09993884917929494 -2.6635 0.7069993863412667 0.7069980243702525 -2.7171934962461064e-09 -0.099938867750098 -2.6636 0.7069994195872901 0.7069980567720306 -3.6512695419238517e-09 -0.09993888631526301 -2.6637000000000004 0.7069994528132038 0.7069980891739855 -4.594161284038334e-09 -0.09993890487479176 -2.6638 0.7069994860189186 0.7069981215762118 -5.545648528934577e-09 -0.09993892342868593 -2.6639 0.7069995192043483 0.7069981539788017 -6.505509168690249e-09 -0.0999389419769472 -2.664 0.7069995523694088 0.706998186381846 -7.473519230555281e-09 -0.0999389605195773 -2.6641000000000004 0.7069995855140181 0.7069982187854319 -8.449452935065105e-09 -0.09993897905657793 -2.6642 0.7069996186380971 0.7069982511896449 -9.433082736806653e-09 -0.09993899758795077 -2.6643000000000003 0.706999651741569 0.706998283594568 -1.0424179391205213e-08 -0.0999390161136976 -2.6644 0.7069996848243595 0.7069983160002815 -1.1422511992688344e-08 -0.09993903463382009 -2.6645 0.7069997178863967 0.7069983484068633 -1.2427848038003286e-08 -0.09993905314831997 -2.6646000000000005 0.7069997509276114 0.7069983808143885 -1.343995348389651e-08 -0.09993907165719887 -2.6647000000000003 0.7069997839479367 0.7069984132229299 -1.4458592791349173e-08 -0.09993909016045854 -2.6648 0.7069998169473083 0.706998445632558 -1.5483528986726114e-08 -0.09993910865810068 -2.6649000000000003 0.7069998499256647 0.7069984780433402 -1.6514523715985968e-08 -0.09993912715012698 -2.665 0.7069998828829468 0.7069985104553419 -1.7551337301493358e-08 -0.09993914563653919 -2.6651000000000002 0.7069999158190983 0.7069985428686255 -1.8593728793193237e-08 -0.09993916411733901 -2.6652000000000005 0.7069999487340648 0.7069985752832509 -1.964145603019357e-08 -0.09993918259252807 -2.6653000000000002 0.7069999816277954 0.7069986076992756 -2.069427569020496e-08 -0.09993920106210817 -2.6654 0.7070000145002413 0.7069986401167541 -2.1751943351990682e-08 -0.09993921952608095 -2.6655 0.7070000473513567 0.7069986725357383 -2.28142135495768e-08 -0.09993923798444815 -2.6656000000000004 0.7070000801810981 0.7069987049562778 -2.388083982993172e-08 -0.09993925643721141 -2.6657 0.7070001129894248 0.7069987373784195 -2.495157481151311e-08 -0.09993927488437254 -2.6658000000000004 0.7070001457762989 0.7069987698022069 -2.602617023761064e-08 -0.09993929332593314 -2.6659 0.7070001785416846 0.7069988022276817 -2.710437703619395e-08 -0.09993931176189491 -2.666 0.7070002112855497 0.7069988346548828 -2.8185945377375357e-08 -0.09993933019225962 -2.6661000000000006 0.7070002440078638 0.7069988670838456 -2.9270624734992548e-08 -0.09993934861702886 -2.6662000000000003 0.7070002767085997 0.7069988995146039 -3.035816393626503e-08 -0.09993936703620439 -2.6663 0.7070003093877331 0.7069989319471883 -3.1448311229448356e-08 -0.09993938544978796 -2.6664 0.7070003420452418 0.7069989643816266 -3.254081433392425e-08 -0.09993940385778118 -2.6665 0.7070003746811069 0.706998996817944 -3.363542050221699e-08 -0.09993942226018585 -2.6666000000000003 0.7070004072953118 0.7069990292561625 -3.473187658049187e-08 -0.09993944065700353 -2.6667 0.7070004398878429 0.7069990616963022 -3.582992906374111e-08 -0.09993945904823599 -2.6668000000000003 0.7070004724586889 0.7069990941383801 -3.692932415628233e-08 -0.09993947743388491 -2.6669 0.7070005050078418 0.7069991265824106 -3.802980782857072e-08 -0.099939495813952 -2.667 0.707000537535296 0.7069991590284049 -3.913112587758914e-08 -0.09993951418843895 -2.6671000000000005 0.7070005700410487 0.706999191476372 -4.0233023983606096e-08 -0.09993953255734743 -2.6672000000000002 0.7070006025250999 0.7069992239263178 -4.133524777213786e-08 -0.09993955092067915 -2.6673 0.7070006349874522 0.7069992563782459 -4.2437542869649394e-08 -0.09993956927843585 -2.6674 0.7070006674281109 0.7069992888321566 -4.3539654963354864e-08 -0.09993958763061914 -2.6675 0.7070006998470844 0.7069993212880479 -4.4641329859920406e-08 -0.09993960597723074 -2.6676 0.707000732244383 0.7069993537459148 -4.5742313544349864e-08 -0.09993962431827232 -2.6677000000000004 0.7070007646200208 0.7069993862057501 -4.684235223648527e-08 -0.09993964265374565 -2.6678 0.707000796974014 0.7069994186675431 -4.794119245251499e-08 -0.09993966098365237 -2.6679 0.7070008293063815 0.7069994511312808 -4.903858106261941e-08 -0.09993967930799413 -2.668 0.707000861617145 0.7069994835969478 -5.013426534810836e-08 -0.0999396976267727 -2.6681000000000004 0.7070008939063289 0.706999516064525 -5.122799305720335e-08 -0.09993971593998967 -2.6682 0.7070009261739605 0.7069995485339919 -5.2319512471119684e-08 -0.09993973424764681 -2.6683000000000003 0.7070009584200694 0.7069995810053245 -5.340857245307237e-08 -0.09993975254974574 -2.6684 0.7070009906446881 0.7069996134784959 -5.449492251050937e-08 -0.09993977084628823 -2.6685 0.7070010228478523 0.7069996459534773 -5.557831285235744e-08 -0.09993978913727593 -2.6686000000000005 0.7070010550295991 0.7069996784302366 -5.6658494446918534e-08 -0.09993980742271047 -2.6687000000000003 0.7070010871899697 0.706999710908739 -5.7735219076513605e-08 -0.0999398257025936 -2.6688 0.7070011193290067 0.7069997433889476 -5.880823939798108e-08 -0.09993984397692696 -2.6689000000000003 0.7070011514467562 0.7069997758708224 -5.987730899601959e-08 -0.09993986224571226 -2.669 0.707001183543267 0.706999808354321 -6.09421824410844e-08 -0.0999398805089512 -2.6691000000000003 0.7070012156185899 0.706999840839398 -6.200261534880167e-08 -0.09993989876664543 -2.6692000000000005 0.7070012476727785 0.706999873326006 -6.305836443070909e-08 -0.09993991701879668 -2.6693000000000002 0.7070012797058893 0.7069999058140943 -6.410918755453757e-08 -0.09993993526540657 -2.6694 0.7070013117179808 0.7069999383036103 -6.51548437966866e-08 -0.09993995350647679 -2.6695 0.7070013437091149 0.7069999707944983 -6.619509349816907e-08 -0.09993997174200905 -2.6696000000000004 0.7070013756793553 0.7070000032867001 -6.722969832185718e-08 -0.099939989972005 -2.6697 0.7070014076287687 0.7070000357801554 -6.825842130105467e-08 -0.09994000819646637 -2.6698000000000004 0.7070014395574244 0.7070000682748008 -6.928102690151317e-08 -0.09994002641539479 -2.6699 0.7070014714653936 0.707000100770571 -7.029728107173921e-08 -0.099940044628792 -2.67 0.7070015033527507 0.7070001332673975 -7.130695129590331e-08 -0.09994006283665963 -2.6701000000000006 0.7070015352195719 0.7070001657652096 -7.230980664501424e-08 -0.0999400810389993 -2.6702000000000004 0.7070015670659364 0.7070001982639347 -7.33056178358997e-08 -0.0999400992358128 -2.6703 0.7070015988919256 0.7070002307634966 -7.429415727630909e-08 -0.09994011742710168 -2.6704 0.7070016306976237 0.7070002632638183 -7.527519912259306e-08 -0.09994013561286783 -2.6705 0.7070016624831168 0.7070002957648187 -7.624851933001053e-08 -0.09994015379311276 -2.6706000000000003 0.7070016942484931 0.7070003282664152 -7.721389570173459e-08 -0.09994017196783811 -2.6707 0.7070017259938444 0.7070003607685228 -7.817110794089421e-08 -0.09994019013704568 -2.6708000000000003 0.7070017577192635 0.7070003932710537 -7.911993770131492e-08 -0.09994020830073702 -2.6709 0.7070017894248464 0.7070004257739186 -8.00601686395605e-08 -0.09994022645891391 -2.671 0.707001821110691 0.7070004582770253 -8.099158645483162e-08 -0.09994024461157797 -2.6711000000000005 0.7070018527768975 0.7070004907802793 -8.191397895054853e-08 -0.09994026275873089 -2.6712000000000002 0.7070018844235686 0.7070005232835841 -8.282713607338232e-08 -0.09994028090037435 -2.6713 0.7070019160508089 0.7070005557868408 -8.373084996356195e-08 -0.09994029903650997 -2.6714 0.7070019476587251 0.7070005882899485 -8.46249150086506e-08 -0.09994031716713947 -2.6715 0.7070019792474267 0.7070006207928038 -8.550912787563814e-08 -0.09994033529226448 -2.6716 0.7070020108170247 0.7070006532953015 -8.638328757165636e-08 -0.09994035341188671 -2.6717000000000004 0.707002042367633 0.7070006857973341 -8.724719548301035e-08 -0.09994037152600785 -2.6718 0.7070020738993666 0.7070007182987919 -8.810065542028123e-08 -0.0999403896346295 -2.6719 0.7070021054123434 0.7070007507995633 -8.894347366429634e-08 -0.09994040773775342 -2.672 0.707002136906683 0.7070007832995342 -8.977545901556888e-08 -0.09994042583538117 -2.6721000000000004 0.7070021683825068 0.7070008157985894 -9.059642282378821e-08 -0.09994044392751451 -2.6722 0.7070021998399387 0.707000848296611 -9.140617903465736e-08 -0.09994046201415509 -2.6723000000000003 0.7070022312791042 0.707000880793479 -9.220454424800628e-08 -0.09994048009530448 -2.6724 0.7070022627001308 0.707000913289072 -9.299133773860851e-08 -0.09994049817096445 -2.6725 0.7070022941031481 0.7070009457832664 -9.376638150735556e-08 -0.09994051624113666 -2.6726000000000005 0.7070023254882873 0.7070009782759368 -9.452950032115548e-08 -0.09994053430582275 -2.6727000000000003 0.7070023568556818 0.7070010107669555 -9.52805217502295e-08 -0.09994055236502439 -2.6728 0.7070023882054666 0.707001043256194 -9.601927620714323e-08 -0.09994057041874324 -2.6729000000000003 0.7070024195377782 0.707001075743521 -9.674559698497065e-08 -0.09994058846698096 -2.673 0.707002450852755 0.7070011082288039 -9.745932030066212e-08 -0.09994060650973921 -2.6731000000000003 0.7070024821505381 0.7070011407119084 -9.816028532193266e-08 -0.09994062454701969 -2.6732000000000005 0.7070025134312685 0.7070011731926986 -9.884833421063e-08 -0.09994064257882404 -2.6733000000000002 0.7070025446950903 0.7070012056710365 -9.952331215222487e-08 -0.09994066060515389 -2.6734 0.7070025759421485 0.7070012381467828 -1.0018506740004651e-07 -0.09994067862601093 -2.6735 0.7070026071725902 0.7070012706197966 -1.0083345130390553e-07 -0.0999406966413968 -2.6736000000000004 0.7070026383865635 0.7070013030899354 -1.0146831834131897e-07 -0.0999407146513132 -2.6737 0.7070026695842184 0.7070013355570548 -1.0208952614786798e-07 -0.09994073265576171 -2.6738000000000004 0.7070027007657063 0.70700136802101 -1.0269693555536169e-07 -0.09994075065474409 -2.6739 0.7070027319311801 0.7070014004816536 -1.032904106291338e-07 -0.09994076864826196 -2.674 0.7070027630807939 0.7070014329388372 -1.03869818681053e-07 -0.09994078663631695 -2.6741 0.7070027942147035 0.7070014653924112 -1.0443503031115631e-07 -0.09994080461891072 -2.6742000000000004 0.7070028253330656 0.7070014978422241 -1.0498591943887414e-07 -0.09994082259604495 -2.6743 0.7070028564360389 0.7070015302881241 -1.0552236331864279e-07 -0.09994084056772133 -2.6744 0.7070028875237828 0.7070015627299568 -1.060442425763336e-07 -0.09994085853394143 -2.6745 0.7070029185964581 0.7070015951675679 -1.0655144123440652e-07 -0.09994087649470701 -2.6746000000000003 0.7070029496542272 0.7070016276008007 -1.0704384673793088e-07 -0.09994089445001966 -2.6747 0.7070029806972526 0.7070016600294979 -1.0752134998147367e-07 -0.09994091239988105 -2.6748000000000003 0.7070030117256989 0.7070016924535016 -1.0798384532818145e-07 -0.09994093034429283 -2.6749 0.7070030427397316 0.7070017248726513 -1.084312306297297e-07 -0.0999409482832566 -2.675 0.7070030737395171 0.7070017572867872 -1.0886340726448673e-07 -0.09994096621677406 -2.6751000000000005 0.7070031047252228 0.7070017896957472 -1.0928028014618729e-07 -0.0999409841448469 -2.6752000000000002 0.7070031356970173 0.7070018220993692 -1.09681757736943e-07 -0.09994100206747675 -2.6753 0.70700316665507 0.7070018544974892 -1.1006775209494724e-07 -0.09994101998466526 -2.6754000000000002 0.707003197599551 0.707001886889943 -1.1043817886580154e-07 -0.09994103789641405 -2.6755 0.7070032285306316 0.7070019192765651 -1.1079295732067951e-07 -0.0999410558027248 -2.6756 0.7070032594484836 0.7070019516571894 -1.1113201036153098e-07 -0.09994107370359914 -2.6757000000000004 0.7070032903532797 0.707001984031649 -1.1145526452975563e-07 -0.09994109159903869 -2.6758 0.7070033212451938 0.7070020163997768 -1.1176265005304054e-07 -0.09994110948904522 -2.6759 0.7070033521243997 0.7070020487614035 -1.120541008332171e-07 -0.09994112737362028 -2.676 0.7070033829910726 0.7070020811163608 -1.1232955446013881e-07 -0.09994114525276555 -2.6761000000000004 0.7070034138453873 0.7070021134644784 -1.1258895224464105e-07 -0.0999411631264826 -2.6762 0.7070034446875206 0.7070021458055867 -1.1283223921333685e-07 -0.0999411809947732 -2.6763000000000003 0.7070034755176489 0.7070021781395145 -1.1305936413290307e-07 -0.0999411988576389 -2.6764 0.7070035063359492 0.7070022104660907 -1.1327027950834567e-07 -0.0999412167150814 -2.6765 0.7070035371425991 0.7070022427851436 -1.1346494158993858e-07 -0.09994123456710234 -2.6766000000000005 0.7070035679377766 0.7070022750965009 -1.1364331040444875e-07 -0.09994125241370336 -2.6767000000000003 0.7070035987216603 0.70700230739999 -1.1380534974993195e-07 -0.0999412702548861 -2.6768 0.7070036294944282 0.707002339695438 -1.1395102719052863e-07 -0.09994128809065214 -2.6769000000000003 0.7070036602562602 0.7070023719826718 -1.140803140859542e-07 -0.09994130592100321 -2.677 0.7070036910073348 0.707002404261518 -1.1419318558456015e-07 -0.09994132374594095 -2.6771000000000003 0.7070037217478323 0.7070024365318027 -1.1428962062333403e-07 -0.099941341565467 -2.6772000000000005 0.707003752477932 0.7070024687933523 -1.1436960193136891e-07 -0.09994135937958297 -2.6773000000000002 0.7070037831978135 0.7070025010459926 -1.1443311605761897e-07 -0.09994137718829053 -2.6774 0.7070038139076572 0.7070025332895495 -1.1448015334661332e-07 -0.09994139499159131 -2.6775 0.7070038446076425 0.7070025655238488 -1.1451070794192553e-07 -0.09994141278948693 -2.6776000000000004 0.7070038752979495 0.7070025977487165 -1.1452477779484715e-07 -0.09994143058197905 -2.6777 0.7070039059787584 0.7070026299639784 -1.1452236465397947e-07 -0.09994144836906929 -2.6778000000000004 0.7070039366502489 0.7070026621694604 -1.1450347408084594e-07 -0.09994146615075933 -2.6779 0.7070039673126008 0.7070026943649887 -1.1446811542907553e-07 -0.09994148392705081 -2.678 0.7070039979659939 0.7070027265503891 -1.1441630184613749e-07 -0.09994150169794533 -2.6781 0.7070040286106074 0.7070027587254883 -1.1434805028374961e-07 -0.09994151946344455 -2.6782000000000004 0.7070040592466207 0.7070027908901124 -1.1426338147185744e-07 -0.09994153722355008 -2.6783 0.7070040898742127 0.7070028230440886 -1.1416231992036896e-07 -0.09994155497826357 -2.6784 0.7070041204935618 0.707002855187244 -1.1404489391221573e-07 -0.09994157272758665 -2.6785 0.7070041511048465 0.7070028873194061 -1.1391113551029175e-07 -0.09994159047152094 -2.6786000000000003 0.7070041817082447 0.7070029194404028 -1.1376108051582012e-07 -0.09994160821006814 -2.6787 0.7070042123039337 0.7070029515500624 -1.1359476849437389e-07 -0.09994162594322983 -2.6788000000000003 0.7070042428920907 0.7070029836482139 -1.1341224274118156e-07 -0.09994164367100769 -2.6789 0.7070042734728919 0.7070030157346865 -1.1321355028633129e-07 -0.0999416613934033 -2.679 0.7070043040465135 0.7070030478093099 -1.129987418670153e-07 -0.0999416791104183 -2.6791000000000005 0.7070043346131305 0.7070030798719146 -1.1276787192579518e-07 -0.09994169682205434 -2.6792000000000002 0.7070043651729176 0.7070031119223319 -1.1252099860019349e-07 -0.09994171452831303 -2.6793 0.7070043957260492 0.7070031439603934 -1.1225818369146878e-07 -0.09994173222919608 -2.6794000000000002 0.7070044262726983 0.7070031759859317 -1.1197949266635032e-07 -0.09994174992470503 -2.6795 0.7070044568130378 0.7070032079987798 -1.1168499463101722e-07 -0.09994176761484161 -2.6796 0.7070044873472391 0.7070032399987716 -1.1137476232415955e-07 -0.0999417852996073 -2.6797000000000004 0.7070045178754732 0.7070032719857422 -1.1104887208575331e-07 -0.09994180297900385 -2.6798 0.7070045483979104 0.7070033039595272 -1.1070740384144795e-07 -0.09994182065303285 -2.6799 0.7070045789147195 0.707003335919963 -1.1035044110083159e-07 -0.09994183832169591 -2.68 0.7070046094260691 0.7070033678668874 -1.0997807090191991e-07 -0.09994185598499469 -2.6801000000000004 0.7070046399321264 0.7070033998001388 -1.0959038382676867e-07 -0.09994187364293083 -2.6802 0.7070046704330575 0.7070034317195568 -1.091874739598403e-07 -0.09994189129550596 -2.6803000000000003 0.7070047009290277 0.7070034636249818 -1.0876943887065671e-07 -0.09994190894272165 -2.6804 0.7070047314202008 0.7070034955162556 -1.083363795860437e-07 -0.09994192658457957 -2.6805 0.7070047619067403 0.7070035273932209 -1.0788840056237536e-07 -0.09994194422108132 -2.6806000000000005 0.7070047923888074 0.7070035592557216 -1.074256096725637e-07 -0.09994196185222853 -2.6807000000000003 0.7070048228665631 0.7070035911036031 -1.0694811817570093e-07 -0.09994197947802287 -2.6808 0.7070048533401667 0.7070036229367116 -1.064560406806303e-07 -0.0999419970984659 -2.6809000000000003 0.707004883809776 0.7070036547548947 -1.0594949513727248e-07 -0.09994201471355926 -2.681 0.7070049142755481 0.7070036865580014 -1.054286027941248e-07 -0.0999420323233046 -2.6811000000000003 0.7070049447376385 0.7070037183458822 -1.0489348816530158e-07 -0.09994204992770356 -2.6812000000000005 0.707004975196201 0.7070037501183886 -1.0434427901578891e-07 -0.09994206752675769 -2.6813000000000002 0.7070050056513881 0.7070037818753736 -1.0378110631720922e-07 -0.09994208512046862 -2.6814 0.7070050361033514 0.7070038136166921 -1.0320410423134141e-07 -0.09994210270883805 -2.6815 0.7070050665522405 0.7070038453421996 -1.0261341005807917e-07 -0.09994212029186753 -2.6816000000000004 0.7070050969982035 0.7070038770517542 -1.0200916422588996e-07 -0.09994213786955874 -2.6817 0.7070051274413869 0.7070039087452146 -1.0139151023977333e-07 -0.09994215544191323 -2.6818 0.7070051578819361 0.7070039404224416 -1.0076059466217896e-07 -0.09994217300893266 -2.6819 0.7070051883199943 0.7070039720832975 -1.0011656705836286e-07 -0.09994219057061864 -2.682 0.7070052187557032 0.7070040037276462 -9.945957998511168e-08 -0.09994220812697278 -2.6821 0.7070052491892035 0.707004035355353 -9.878978893696627e-08 -0.09994222567799674 -2.6822000000000004 0.7070052796206331 0.7070040669662857 -9.810735231152723e-08 -0.09994224322369205 -2.6823 0.707005310050129 0.7070040985603132 -9.741243138343403e-08 -0.09994226076406047 -2.6824 0.7070053404778258 0.707004130137306 -9.670519025579277e-08 -0.09994227829910347 -2.6825 0.7070053709038567 0.707004161697137 -9.598579582114491e-08 -0.09994229582882273 -2.6826000000000003 0.7070054013283531 0.7070041932396803 -9.525441772850751e-08 -0.09994231335321985 -2.6827 0.7070054317514445 0.7070042247648125 -9.451122833653569e-08 -0.09994233087229645 -2.6828000000000003 0.7070054621732584 0.7070042562724115 -9.375640268143026e-08 -0.09994234838605416 -2.6829 0.7070054925939204 0.7070042877623575 -9.299011842142657e-08 -0.09994236589449457 -2.683 0.7070055230135546 0.7070043192345326 -9.221255581771254e-08 -0.09994238339761935 -2.6831000000000005 0.7070055534322819 0.7070043506888206 -9.142389767197862e-08 -0.09994240089543005 -2.6832000000000003 0.7070055838502225 0.7070043821251076 -9.062432928738651e-08 -0.09994241838792828 -2.6833 0.7070056142674943 0.7070044135432816 -8.981403843300734e-08 -0.0999424358751157 -2.6834000000000002 0.7070056446842126 0.7070044449432323 -8.899321528917786e-08 -0.09994245335699385 -2.6835 0.7070056751004914 0.7070044763248524 -8.8162052412806e-08 -0.09994247083356445 -2.6836 0.7070057055164417 0.7070045076880355 -8.732074468446177e-08 -0.09994248830482899 -2.6837000000000004 0.7070057359321733 0.7070045390326786 -8.646948927368281e-08 -0.0999425057707892 -2.6838 0.7070057663477931 0.7070045703586796 -8.560848557652434e-08 -0.09994252323144659 -2.6839 0.7070057967634062 0.7070046016659395 -8.473793517826261e-08 -0.09994254068680282 -2.684 0.7070058271791158 0.7070046329543607 -8.385804180655737e-08 -0.09994255813685948 -2.6841000000000004 0.707005857595022 0.7070046642238486 -8.296901128634904e-08 -0.09994257558161818 -2.6842 0.7070058880112238 0.7070046954743103 -8.207105148521493e-08 -0.09994259302108054 -2.6843000000000004 0.707005918427817 0.7070047267056554 -8.116437226392964e-08 -0.09994261045524815 -2.6844 0.7070059488448956 0.707004757917796 -8.024918544003584e-08 -0.09994262788412267 -2.6845 0.7070059792625512 0.7070047891106457 -7.932570472279216e-08 -0.09994264530770564 -2.6846000000000005 0.7070060096808726 0.7070048202841211 -7.839414566893771e-08 -0.09994266272599865 -2.6847000000000003 0.7070060400999473 0.7070048514381411 -7.745472563932404e-08 -0.09994268013900337 -2.6848 0.7070060705198594 0.7070048825726267 -7.65076637399345e-08 -0.09994269754672132 -2.6849000000000003 0.7070061009406914 0.7070049136875016 -7.555318077244466e-08 -0.0999427149491542 -2.685 0.707006131362523 0.7070049447826915 -7.459149917957847e-08 -0.09994273234630359 -2.6851000000000003 0.7070061617854315 0.7070049758581247 -7.362284300737806e-08 -0.09994274973817108 -2.6852000000000005 0.7070061922094919 0.7070050069137319 -7.264743783277905e-08 -0.0999427671247582 -2.6853000000000002 0.7070062226347767 0.7070050379494464 -7.166551072804866e-08 -0.09994278450606668 -2.6854 0.7070062530613559 0.7070050689652037 -7.067729020007046e-08 -0.09994280188209802 -2.6855 0.707006283489297 0.7070050999609419 -6.968300613439948e-08 -0.09994281925285388 -2.6856000000000004 0.7070063139186653 0.7070051309366016 -6.868288974712367e-08 -0.09994283661833585 -2.6857 0.7070063443495236 0.7070051618921259 -6.767717353368952e-08 -0.09994285397854555 -2.6858 0.7070063747819315 0.7070051928274603 -6.666609120862046e-08 -0.09994287133348455 -2.6859 0.7070064052159466 0.707005223742553 -6.564987765217412e-08 -0.09994288868315443 -2.686 0.7070064356516241 0.7070052546373546 -6.462876885830054e-08 -0.09994290602755683 -2.6861 0.7070064660890165 0.7070052855118183 -6.360300187696274e-08 -0.0999429233666933 -2.6862000000000004 0.7070064965281737 0.7070053163658998 -6.257281476426332e-08 -0.09994294070056549 -2.6863 0.7070065269691428 0.7070053471995575 -6.153844652042814e-08 -0.09994295802917502 -2.6864 0.7070065574119688 0.7070053780127523 -6.050013704123405e-08 -0.09994297535252339 -2.6865 0.7070065878566938 0.7070054088054476 -5.94581270546915e-08 -0.0999429926706123 -2.6866000000000003 0.7070066183033572 0.7070054395776093 -5.8412658072472257e-08 -0.09994300998344322 -2.6867 0.7070066487519963 0.7070054703292066 -5.736397233309723e-08 -0.0999430272910179 -2.6868000000000003 0.707006679202645 0.7070055010602101 -5.631231273840222e-08 -0.09994304459333776 -2.6869 0.7070067096553354 0.7070055317705941 -5.525792280604985e-08 -0.09994306189040453 -2.687 0.7070067401100966 0.7070055624603353 -5.420104660903112e-08 -0.09994307918221979 -2.6871000000000005 0.7070067705669548 0.7070055931294126 -5.3141928719937365e-08 -0.09994309646878508 -2.6872000000000003 0.7070068010259342 0.7070056237778077 -5.208081415263022e-08 -0.09994311375010201 -2.6873 0.7070068314870558 0.7070056544055052 -5.101794831128409e-08 -0.0999431310261722 -2.6874000000000002 0.7070068619503384 0.7070056850124923 -4.995357692674351e-08 -0.09994314829699726 -2.6875 0.7070068924157975 0.7070057155987581 -4.8887946002204585e-08 -0.09994316556257869 -2.6876 0.7070069228834469 0.7070057461642958 -4.782130175867965e-08 -0.09994318282291817 -2.6877000000000004 0.7070069533532968 0.7070057767090997 -4.675389057601665e-08 -0.09994320007801726 -2.6878 0.7070069838253555 0.7070058072331677 -4.5685958934677494e-08 -0.09994321732787753 -2.6879 0.7070070142996282 0.7070058377365003 -4.4617753362286884e-08 -0.09994323457250062 -2.688 0.7070070447761175 0.7070058682191 -4.354952037367594e-08 -0.09994325181188807 -2.6881000000000004 0.7070070752548238 0.7070058986809726 -4.2481506415977514e-08 -0.0999432690460415 -2.6882 0.707007105735744 0.7070059291221262 -4.1413957811410823e-08 -0.09994328627496246 -2.6883000000000004 0.7070071362188732 0.7070059595425718 -4.034712069870064e-08 -0.09994330349865257 -2.6884 0.7070071667042033 0.7070059899423229 -3.928124097930764e-08 -0.09994332071711338 -2.6885 0.707007197191724 0.7070060203213957 -3.821656425909495e-08 -0.09994333793034658 -2.6886000000000005 0.7070072276814218 0.7070060506798088 -3.71533357911534e-08 -0.09994335513835362 -2.6887000000000003 0.707007258173281 0.707006081017584 -3.6091800420371724e-08 -0.09994337234113616 -2.6888 0.7070072886672834 0.707006111334745 -3.503220252624485e-08 -0.0999433895386958 -2.6889000000000003 0.707007319163408 0.7070061416313183 -3.397478596785068e-08 -0.09994340673103408 -2.689 0.7070073496616308 0.7070061719073335 -3.291979402833892e-08 -0.09994342391815263 -2.6891000000000003 0.7070073801619257 0.707006202162822 -3.1867469354757844e-08 -0.09994344110005293 -2.6892000000000005 0.7070074106642641 0.7070062323978188 -3.0818053908072615e-08 -0.09994345827673673 -2.6893000000000002 0.7070074411686144 0.7070062626123605 -2.977178890418465e-08 -0.0999434754482055 -2.6894 0.7070074716749424 0.7070062928064873 -2.8728914757986806e-08 -0.09994349261446088 -2.6895 0.7070075021832114 0.7070063229802406 -2.7689671029370103e-08 -0.09994350977550433 -2.6896000000000004 0.7070075326933825 0.7070063531336659 -2.6654296367278896e-08 -0.09994352693133755 -2.6897 0.7070075632054138 0.7070063832668101 -2.5623028459403896e-08 -0.0999435440819621 -2.6898 0.707007593719261 0.7070064133797231 -2.4596103969515282e-08 -0.09994356122737952 -2.6899 0.7070076242348778 0.7070064434724577 -2.3573758490842006e-08 -0.09994357836759148 -2.69 0.7070076547522145 0.7070064735450681 -2.255622648730804e-08 -0.09994359550259946 -2.6901 0.7070076852712195 0.7070065035976121 -2.1543741239755942e-08 -0.09994361263240512 -2.6902000000000004 0.7070077157918381 0.7070065336301495 -2.053653479867565e-08 -0.09994362975700996 -2.6903 0.7070077463140136 0.7070065636427427 -1.9534837919586018e-08 -0.0999436468764156 -2.6904 0.7070077768376871 0.7070065936354566 -1.8538880023569876e-08 -0.09994366399062361 -2.6905 0.7070078073627967 0.7070066236083583 -1.7548889133089246e-08 -0.09994368109963558 -2.6906000000000003 0.7070078378892783 0.7070066535615176 -1.6565091831219347e-08 -0.09994369820345309 -2.6907 0.7070078684170653 0.7070066834950064 -1.5587713197897507e-08 -0.09994371530207767 -2.6908000000000003 0.7070078989460891 0.7070067134088999 -1.4616976763952988e-08 -0.099943732395511 -2.6909 0.7070079294762779 0.7070067433032741 -1.365310446166737e-08 -0.09994374948375453 -2.691 0.7070079600075583 0.7070067731782088 -1.2696316574033889e-08 -0.09994376656680992 -2.6911000000000005 0.7070079905398539 0.7070068030337853 -1.1746831681848369e-08 -0.09994378364467865 -2.6912000000000003 0.7070080210730867 0.7070068328700877 -1.08048666121012e-08 -0.09994380071736238 -2.6913 0.707008051607176 0.7070068626872024 -9.870636397645016e-09 -0.09994381778486268 -2.6914000000000002 0.7070080821420388 0.7070068924852175 -8.944354215612016e-09 -0.09994383484718111 -2.6915 0.7070081126775899 0.7070069222642243 -8.026231347948998e-09 -0.09994385190431924 -2.6916 0.7070081432137418 0.7070069520243153 -7.1164771246051695e-09 -0.09994386895627862 -2.6917000000000004 0.7070081737504048 0.7070069817655862 -6.215298890138721e-09 -0.09994388600306084 -2.6918 0.7070082042874868 0.7070070114881342 -5.322901944736225e-09 -0.09994390304466744 -2.6919 0.707008234824894 0.7070070411920588 -4.439489493905657e-09 -0.09994392008110004 -2.692 0.7070082653625303 0.707007070877462 -3.565262618986098e-09 -0.09994393711236016 -2.6921000000000004 0.7070082959002972 0.7070071005444478 -2.700420218167132e-09 -0.09994395413844948 -2.6922 0.7070083264380942 0.7070071301931222 -1.8451589587839545e-09 -0.09994397115936948 -2.6923000000000004 0.7070083569758187 0.7070071598235932 -9.99673244357624e-10 -0.09994398817512172 -2.6924 0.7070083875133659 0.707007189435971 -1.6415516342072056e-10 -0.09994400518570777 -2.6925 0.7070084180506295 0.7070072190303677 6.612055590549115e-10 -0.09994402219112923 -2.6926000000000005 0.7070084485875006 0.7070072486068976 1.4762215894137398e-09 -0.09994403919138763 -2.6927000000000003 0.7070084791238684 0.7070072781656768 2.280708046031865e-09 -0.09994405618648453 -2.6928 0.7070085096596208 0.7070073077068236 3.074482527939959e-09 -0.09994407317642157 -2.6929000000000003 0.7070085401946431 0.7070073372304579 3.85736515819135e-09 -0.09994409016120026 -2.693 0.7070085707288187 0.7070073667367021 4.629178635036368e-09 -0.09994410714082219 -2.6931000000000003 0.7070086012620295 0.7070073962256793 5.389748259677918e-09 -0.09994412411528891 -2.6932000000000005 0.707008631794155 0.7070074256975158 6.138901975302757e-09 -0.09994414108460198 -2.6933000000000002 0.7070086623250733 0.7070074551523389 6.876470419123204e-09 -0.09994415804876293 -2.6934 0.7070086928546608 0.7070074845902777 7.602286947530623e-09 -0.09994417500777338 -2.6935 0.7070087233827922 0.7070075140114638 8.316187677728792e-09 -0.09994419196163488 -2.6936000000000004 0.7070087539093399 0.7070075434160292 9.018011532836712e-09 -0.099944208910349 -2.6937 0.7070087844341753 0.707007572804109 9.707600264440008e-09 -0.09994422585391728 -2.6938 0.7070088149571674 0.7070076021758389 1.0384798495959024e-08 -0.09994424279234128 -2.6939 0.7070088454781843 0.7070076315313567 1.1049453754741201e-08 -0.09994425972562258 -2.694 0.7070088759970918 0.7070076608708018 1.1701416511959717e-08 -0.09994427665376265 -2.6941 0.7070089065137548 0.7070076901943154 1.2340540208634343e-08 -0.09994429357676321 -2.6942000000000004 0.7070089370280367 0.7070077195020397 1.2966681298999527e-08 -0.09994431049462577 -2.6943 0.7070089675397986 0.7070077487941189 1.357969926264746e-08 -0.09994432740735187 -2.6944 0.7070089980489006 0.707007778070698 1.4179456660906586e-08 -0.09994434431494303 -2.6945 0.7070090285552014 0.707007807331924 1.4765819155056203e-08 -0.09994436121740083 -2.6946000000000003 0.7070090590585582 0.7070078365779455 1.5338655533214673e-08 -0.09994437811472683 -2.6947 0.7070090895588268 0.7070078658089116 1.589783774329917e-08 -0.09994439500692257 -2.6948000000000003 0.7070091200558619 0.7070078950249739 1.64432409242507e-08 -0.09994441189398967 -2.6949 0.7070091505495166 0.707007924226284 1.6974743432922323e-08 -0.09994442877592959 -2.695 0.707009181039643 0.707007953412996 1.749222686489582e-08 -0.09994444565274398 -2.6951000000000005 0.707009211526092 0.7070079825852644 1.799557609004354e-08 -0.09994446252443435 -2.6952000000000003 0.7070092420087126 0.7070080117432453 1.8484679274212434e-08 -0.09994447939100226 -2.6953 0.7070092724873535 0.7070080408870958 1.8959427905244908e-08 -0.09994449625244924 -2.6954000000000002 0.707009302961862 0.7070080700169741 1.9419716808591336e-08 -0.09994451310877692 -2.6955 0.7070093334320842 0.7070080991330394 1.9865444182004532e-08 -0.09994452995998676 -2.6956 0.707009363897865 0.7070081282354521 2.0296511616356427e-08 -0.09994454680608034 -2.6957000000000004 0.7070093943590491 0.7070081573243739 2.0712824108648498e-08 -0.09994456364705928 -2.6958 0.7070094248154789 0.7070081863999671 2.111429008889998e-08 -0.09994458048292508 -2.6959 0.707009455266997 0.7070082154623951 2.1500821445301355e-08 -0.09994459731367933 -2.696 0.7070094857134442 0.7070082445118218 2.1872333532887978e-08 -0.09994461413932346 -2.6961000000000004 0.7070095161546615 0.7070082735484123 2.222874520042828e-08 -0.09994463095985912 -2.6962 0.7070095465904881 0.7070083025723326 2.2569978806036284e-08 -0.09994464777528783 -2.6963000000000004 0.707009577020763 0.7070083315837495 2.2895960231916757e-08 -0.09994466458561117 -2.6964 0.7070096074453239 0.7070083605828303 2.3206618893906183e-08 -0.09994468139083065 -2.6965 0.7070096378640087 0.7070083895697434 2.3501887767493623e-08 -0.0999446981909479 -2.6966000000000006 0.7070096682766533 0.7070084185446576 2.378170340863739e-08 -0.09994471498596437 -2.6967000000000003 0.7070096986830942 0.707008447507742 2.404600595376505e-08 -0.09994473177588165 -2.6968 0.7070097290831666 0.7070084764591673 2.4294739130181764e-08 -0.09994474856070129 -2.6969000000000003 0.7070097594767053 0.7070085053991035 2.4527850280356422e-08 -0.0999447653404248 -2.697 0.707009789863545 0.707008534327722 2.474529036018691e-08 -0.09994478211505377 -2.6971000000000003 0.7070098202435189 0.7070085632451946 2.494701396502097e-08 -0.09994479888458972 -2.6972000000000005 0.707009850616461 0.7070085921516933 2.5132979312308956e-08 -0.09994481564903426 -2.6973000000000003 0.7070098809822041 0.7070086210473906 2.530314828844138e-08 -0.09994483240838889 -2.6974 0.7070099113405807 0.7070086499324593 2.5457486420993325e-08 -0.09994484916265513 -2.6975 0.7070099416914231 0.7070086788070722 2.5595962909949477e-08 -0.09994486591183452 -2.6976000000000004 0.7070099720345633 0.7070087076714032 2.5718550620765224e-08 -0.09994488265592864 -2.6977 0.7070100023698331 0.7070087365256257 2.582522608436666e-08 -0.09994489939493897 -2.6978 0.7070100326970641 0.707008765369914 2.5915969523171434e-08 -0.09994491612886713 -2.6979 0.7070100630160879 0.7070087942044421 2.599076482853735e-08 -0.09994493285771468 -2.698 0.7070100933267354 0.7070088230293838 2.6049599586783212e-08 -0.09994494958148309 -2.6981 0.7070101236288382 0.7070088518449138 2.6092465065311043e-08 -0.09994496630017397 -2.6982000000000004 0.7070101539222268 0.7070088806512059 2.611935621607553e-08 -0.09994498301378874 -2.6983 0.7070101842067327 0.7070089094484351 2.6130271684257633e-08 -0.09994499972232906 -2.6984 0.7070102144821868 0.707008938236775 2.6125213794386815e-08 -0.09994501642579638 -2.6985 0.7070102447484208 0.7070089670164004 2.6104188555545194e-08 -0.09994503312419228 -2.6986000000000003 0.7070102750052654 0.7070089957874854 2.6067205664837e-08 -0.09994504981751837 -2.6987 0.7070103052525527 0.7070090245502038 2.6014278490041343e-08 -0.09994506650577611 -2.6988000000000003 0.7070103354901143 0.7070090533047293 2.5945424076551094e-08 -0.0999450831889671 -2.6989 0.7070103657177816 0.7070090820512354 2.586066314390345e-08 -0.09994509986709277 -2.699 0.7070103959353873 0.7070091107898953 2.57600200684327e-08 -0.09994511654015471 -2.6991000000000005 0.7070104261427632 0.7070091395208825 2.5643522885004932e-08 -0.09994513320815449 -2.6992000000000003 0.7070104563397427 0.7070091682443693 2.5511203281813888e-08 -0.09994514987109364 -2.6993 0.7070104865261588 0.7070091969605277 2.5363096576094812e-08 -0.09994516652897362 -2.6994000000000002 0.707010516701845 0.70700922566953 2.519924172626753e-08 -0.09994518318179606 -2.6995 0.7070105468666354 0.707009254371547 2.501968131285448e-08 -0.09994519982956243 -2.6996 0.7070105770203651 0.70700928306675 2.4824461522868213e-08 -0.09994521647227433 -2.6997000000000004 0.7070106071628686 0.7070093117553091 2.4613632142872488e-08 -0.0999452331099332 -2.6998 0.7070106372939816 0.707009340437394 2.4387246541635044e-08 -0.09994524974254065 -2.6999 0.7070106674135407 0.7070093691131739 2.4145361670127596e-08 -0.09994526637009815 -2.7 0.7070106975213828 0.7070093977828171 2.3888038023361924e-08 -0.09994528299260728 -2.7001000000000004 0.7070107276173456 0.7070094264464916 2.3615339656002377e-08 -0.09994529961006961 -2.7002 0.7070107577012676 0.7070094551043642 2.332733413899779e-08 -0.0999453162224866 -2.7003000000000004 0.7070107877729878 0.7070094837566014 2.302409255611204e-08 -0.09994533282985985 -2.7004 0.707010817832346 0.7070095124033685 2.2705689486576808e-08 -0.09994534943219083 -2.7005 0.7070108478791833 0.70700954104483 2.237220298774434e-08 -0.09994536602948106 -2.7006000000000006 0.707010877913341 0.7070095696811497 2.202371456386243e-08 -0.09994538262173208 -2.7007000000000003 0.7070109079346623 0.7070095983124904 2.1660309168676506e-08 -0.09994539920894543 -2.7008 0.7070109379429902 0.7070096269390138 2.1282075156857372e-08 -0.09994541579112265 -2.7009000000000003 0.7070109679381699 0.7070096555608809 2.0889104284001203e-08 -0.09994543236826528 -2.701 0.7070109979200465 0.7070096841782517 2.0481491683210784e-08 -0.09994544894037483 -2.7011000000000003 0.7070110278884668 0.7070097127912849 2.0059335824329505e-08 -0.09994546550745287 -2.7012000000000005 0.7070110578432787 0.7070097414001376 1.9622738513074e-08 -0.09994548206950084 -2.7013000000000003 0.7070110877843306 0.7070097700049668 1.9171804853737595e-08 -0.0999454986265203 -2.7014 0.7070111177114731 0.7070097986059278 1.870664322316945e-08 -0.09994551517851281 -2.7015 0.7070111476245571 0.7070098272031746 1.822736524909052e-08 -0.09994553172547983 -2.7016000000000004 0.7070111775234351 0.7070098557968604 1.7734085778868536e-08 -0.09994554826742297 -2.7017 0.7070112074079611 0.7070098843871366 1.722692286303812e-08 -0.0999455648043437 -2.7018 0.7070112372779901 0.7070099129741536 1.670599771280007e-08 -0.09994558133624358 -2.7019 0.7070112671333781 0.7070099415580605 1.6171434677469954e-08 -0.09994559786312408 -2.702 0.7070112969739835 0.7070099701390047 1.562336122105934e-08 -0.09994561438498678 -2.7021 0.7070113267996653 0.7070099987171323 1.506190787890771e-08 -0.09994563090183316 -2.7022000000000004 0.7070113566102838 0.7070100272925883 1.4487208236865778e-08 -0.09994564741366474 -2.7023 0.7070113864057014 0.7070100558655157 1.38993988948663e-08 -0.09994566392048303 -2.7024 0.7070114161857817 0.7070100844360567 1.3298619432229597e-08 -0.09994568042228963 -2.7025 0.7070114459503898 0.7070101130043512 1.2685012387714245e-08 -0.099945696919086 -2.7026000000000003 0.7070114756993924 0.7070101415705381 1.205872321094481e-08 -0.09994571341087367 -2.7027 0.7070115054326578 0.7070101701347544 1.1419900229452107e-08 -0.09994572989765417 -2.7028000000000003 0.7070115351500559 0.7070101986971354 1.0768694626121789e-08 -0.09994574637942903 -2.7029 0.7070115648514583 0.7070102272578149 1.0105260383683201e-08 -0.09994576285619972 -2.703 0.7070115945367381 0.7070102558169253 9.429754272566315e-09 -0.09994577932796776 -2.7031000000000005 0.7070116242057708 0.7070102843745967 8.742335784114874e-09 -0.09994579579473477 -2.7032000000000003 0.7070116538584328 0.7070103129309577 8.043167120178052e-09 -0.09994581225650213 -2.7033 0.7070116834946025 0.7070103414861353 7.332413147140282e-09 -0.09994582871327148 -2.7034000000000002 0.7070117131141604 0.7070103700402544 6.610241349951085e-09 -0.09994584516504422 -2.7035 0.7070117427169887 0.7070103985934384 5.876821794828513e-09 -0.09994586161182195 -2.7036000000000002 0.7070117723029714 0.7070104271458083 5.132327091962596e-09 -0.09994587805360615 -2.7037000000000004 0.7070118018719942 0.707010455697484 4.376932354749341e-09 -0.09994589449039834 -2.7038 0.7070118314239451 0.7070104842485827 3.6108151590247273e-09 -0.09994591092220007 -2.7039 0.7070118609587136 0.7070105127992206 2.8341554996966223e-09 -0.09994592734901281 -2.704 0.7070118904761915 0.7070105413495108 2.0471357508461407e-09 -0.0999459437708381 -2.7041000000000004 0.7070119199762728 0.7070105698995652 1.249940618022749e-09 -0.09994596018767743 -2.7042 0.7070119494588529 0.7070105984494931 4.427571035497957e-10 -0.09994597659953233 -2.7043000000000004 0.7070119789238294 0.7070106269994024 -3.7422554725191626e-10 -0.09994599300640428 -2.7044 0.7070120083711022 0.7070106555493987 -1.2008158859627693e-09 -0.09994600940829482 -2.7045 0.7070120378005735 0.7070106840995853 -2.0368203018303332e-09 -0.09994602580520545 -2.7046000000000006 0.7070120672121469 0.707010712650064 -2.8820430755457926e-09 -0.09994604219713775 -2.7047000000000003 0.7070120966057287 0.7070107412009334 -3.736286418275225e-09 -0.09994605858409311 -2.7048 0.707012125981227 0.7070107697522912 -4.59935052023186e-09 -0.09994607496607316 -2.7049000000000003 0.7070121553385523 0.7070107983042317 -5.471033595778885e-09 -0.0999460913430793 -2.705 0.7070121846776174 0.707010826856848 -6.35113193286907e-09 -0.09994610771511313 -2.7051000000000003 0.7070122139983368 0.7070108554102306 -7.239439941617021e-09 -0.09994612408217608 -2.7052000000000005 0.7070122433006277 0.7070108839644679 -8.13575019853463e-09 -0.09994614044426975 -2.7053000000000003 0.7070122725844096 0.7070109125196455 -9.039853497705419e-09 -0.09994615680139558 -2.7054 0.707012301849604 0.7070109410758476 -9.951538901091517e-09 -0.09994617315355511 -2.7055 0.7070123310961345 0.7070109696331554 -1.0870593781034388e-08 -0.09994618950074982 -2.7056000000000004 0.7070123603239276 0.707010998191648 -1.1796803876633344e-08 -0.09994620584298124 -2.7057 0.7070123895329117 0.7070110267514026 -1.2729953341016759e-08 -0.09994622218025088 -2.7058 0.7070124187230173 0.7070110553124933 -1.3669824792950092e-08 -0.09994623851256018 -2.7059 0.7070124478941779 0.7070110838749923 -1.461619936323974e-08 -0.09994625483991071 -2.706 0.707012477046329 0.7070111124389696 -1.5568856750244192e-08 -0.09994627116230395 -2.7061 0.7070125061794085 0.7070111410044924 -1.652757527278309e-08 -0.09994628747974142 -2.7062000000000004 0.7070125352933567 0.7070111695716259 -1.7492131913939002e-08 -0.09994630379222462 -2.7063 0.7070125643881164 0.7070111981404326 -1.8462302379604334e-08 -0.09994632009975507 -2.7064 0.7070125934636327 0.7070112267109725 -1.9437861147053592e-08 -0.09994633640233419 -2.7065 0.7070126225198532 0.7070112552833037 -2.0418581523490298e-08 -0.09994635269996363 -2.7066000000000003 0.7070126515567278 0.7070112838574809 -2.1404235689415074e-08 -0.09994636899264471 -2.7067 0.7070126805742094 0.7070113124335574 -2.2394594756738884e-08 -0.09994638528037914 -2.7068000000000003 0.7070127095722527 0.707011341011583 -2.3389428823426817e-08 -0.0999464015631682 -2.7069 0.7070127385508151 0.707011369591606 -2.4388507024238754e-08 -0.09994641784101355 -2.707 0.7070127675098569 0.707011398173672 -2.539159758320475e-08 -0.09994643411391668 -2.7071000000000005 0.7070127964493405 0.7070114267578235 -2.639846786913619e-08 -0.09994645038187909 -2.7072000000000003 0.70701282536923 0.7070114553441007 -2.740888445265481e-08 -0.09994646664490214 -2.7073 0.707012854269494 0.7070114839325417 -2.8422613152379733e-08 -0.09994648290298747 -2.7074000000000003 0.7070128831501017 0.7070115125231817 -2.943941909781117e-08 -0.09994649915613656 -2.7075 0.7070129120110261 0.7070115411160536 -3.045906677681849e-08 -0.09994651540435087 -2.7076000000000002 0.7070129408522422 0.7070115697111874 -3.148132009462082e-08 -0.09994653164763194 -2.7077000000000004 0.7070129696737273 0.707011598308611 -3.250594242778029e-08 -0.09994654788598122 -2.7078 0.7070129984754618 0.7070116269083495 -3.3532696676243784e-08 -0.09994656411940023 -2.7079 0.7070130272574283 0.7070116555104256 -3.4561345319721395e-08 -0.09994658034789046 -2.708 0.7070130560196122 0.707011684114859 -3.55916504730892e-08 -0.09994659657145341 -2.7081000000000004 0.7070130847620011 0.7070117127216673 -3.662337394330986e-08 -0.09994661279009055 -2.7082 0.7070131134845854 0.7070117413308656 -3.765627728169116e-08 -0.09994662900380341 -2.7083000000000004 0.7070131421873581 0.7070117699424661 -3.8690121838421375e-08 -0.09994664521259347 -2.7084 0.7070131708703148 0.7070117985564788 -3.972466881900201e-08 -0.09994666141646225 -2.7085 0.7070131995334534 0.7070118271729107 -4.075967934035526e-08 -0.09994667761541122 -2.7086000000000006 0.7070132281767748 0.7070118557917666 -4.1794914484708824e-08 -0.09994669380944192 -2.7087000000000003 0.7070132568002818 0.7070118844130482 -4.283013535307423e-08 -0.0999467099985557 -2.7088 0.7070132854039806 0.7070119130367556 -4.386510312483048e-08 -0.09994672618275423 -2.7089000000000003 0.7070133139878789 0.7070119416628852 -4.4899579108457956e-08 -0.09994674236203885 -2.709 0.7070133425519882 0.7070119702914317 -4.593332479825574e-08 -0.09994675853641116 -2.7091000000000003 0.7070133710963218 0.707011998922387 -4.696610193160103e-08 -0.09994677470587261 -2.7092 0.7070133996208956 0.7070120275557402 -4.799767253939845e-08 -0.09994679087042471 -2.7093000000000003 0.7070134281257281 0.7070120561914781 -4.902779900247886e-08 -0.09994680703006895 -2.7094 0.7070134566108406 0.7070120848295849 -5.005624410803211e-08 -0.09994682318480677 -2.7095 0.7070134850762566 0.707012113470042 -5.10827711042508e-08 -0.09994683933463971 -2.7096000000000005 0.7070135135220021 0.7070121421128288 -5.2107143751721485e-08 -0.09994685547956922 -2.7097 0.7070135419481058 0.7070121707579218 -5.312912637936949e-08 -0.09994687161959678 -2.7098 0.7070135703545993 0.7070121994052947 -5.414848394192165e-08 -0.09994688775472392 -2.7099 0.707013598741516 0.7070122280549194 -5.516498206804485e-08 -0.09994690388495212 -2.71 0.7070136271088925 0.7070122567067649 -5.617838711715825e-08 -0.09994692001028285 -2.7101 0.7070136554567673 0.7070122853607976 -5.718846623494443e-08 -0.09994693613071765 -2.7102000000000004 0.7070136837851817 0.7070123140169813 -5.819498740430688e-08 -0.09994695224625791 -2.7103 0.7070137120941794 0.707012342675278 -5.919771949849592e-08 -0.09994696835690521 -2.7104 0.7070137403838064 0.7070123713356464 -6.01964323353188e-08 -0.09994698446266093 -2.7105 0.7070137686541116 0.7070123999980431 -6.1190896732434e-08 -0.09994700056352664 -2.7106000000000003 0.7070137969051458 0.7070124286624224 -6.218088455071935e-08 -0.09994701665950377 -2.7107 0.7070138251369631 0.7070124573287362 -6.316616875997466e-08 -0.0999470327505939 -2.7108000000000003 0.7070138533496191 0.7070124859969333 -6.414652347882036e-08 -0.09994704883679838 -2.7109 0.707013881543172 0.7070125146669612 -6.512172403497912e-08 -0.09994706491811879 -2.711 0.707013909717683 0.7070125433387637 -6.609154701254713e-08 -0.0999470809945566 -2.7111000000000005 0.7070139378732148 0.7070125720122834 -6.705577030273469e-08 -0.09994709706611322 -2.7112000000000003 0.7070139660098329 0.7070126006874597 -6.80141731567753e-08 -0.09994711313279017 -2.7113 0.7070139941276056 0.7070126293642303 -6.896653623493162e-08 -0.09994712919458897 -2.7114000000000003 0.707014022226603 0.70701265804253 -6.991264166027189e-08 -0.0999471452515111 -2.7115 0.7070140503068976 0.7070126867222916 -7.085227305900221e-08 -0.09994716130355803 -2.7116000000000002 0.7070140783685639 0.7070127154034455 -7.178521562335033e-08 -0.0999471773507312 -2.7117000000000004 0.7070141064116793 0.7070127440859197 -7.271125615276527e-08 -0.09994719339303211 -2.7118 0.7070141344363231 0.7070127727696401 -7.363018310075492e-08 -0.09994720943046224 -2.7119 0.707014162442577 0.7070128014545303 -7.454178662909608e-08 -0.09994722546302305 -2.712 0.7070141904305249 0.7070128301405115 -7.544585865033523e-08 -0.09994724149071604 -2.7121000000000004 0.7070142184002528 0.7070128588275032 -7.634219287809552e-08 -0.09994725751354268 -2.7122 0.707014246351849 0.7070128875154224 -7.723058487434792e-08 -0.0999472735315045 -2.7123000000000004 0.7070142742854041 0.7070129162041833 -7.811083209321307e-08 -0.09994728954460289 -2.7124 0.7070143022010105 0.707012944893699 -7.898273393473765e-08 -0.0999473055528394 -2.7125 0.7070143300987629 0.7070129735838799 -7.984609177655311e-08 -0.09994732155621544 -2.7126000000000006 0.7070143579787582 0.7070130022746344 -8.07007090363257e-08 -0.09994733755473252 -2.7127000000000003 0.7070143858410951 0.7070130309658685 -8.15463912055836e-08 -0.09994735354839206 -2.7128 0.7070144136858749 0.7070130596574868 -8.238294589221762e-08 -0.0999473695371956 -2.7129000000000003 0.7070144415132005 0.7070130883493912 -8.321018287078819e-08 -0.09994738552114456 -2.713 0.7070144693231769 0.7070131170414826 -8.402791412329136e-08 -0.09994740150024051 -2.7131000000000003 0.7070144971159111 0.7070131457336584 -8.483595387905746e-08 -0.09994741747448485 -2.7132 0.7070145248915123 0.707013174425815 -8.563411866332332e-08 -0.09994743344387905 -2.7133000000000003 0.7070145526500913 0.7070132031178469 -8.642222733626359e-08 -0.09994744940842461 -2.7134 0.7070145803917607 0.7070132318096463 -8.720010112681781e-08 -0.09994746536812298 -2.7135 0.7070146081166355 0.7070132605011036 -8.796756368733422e-08 -0.09994748132297564 -2.7136000000000005 0.7070146358248323 0.7070132891921076 -8.87244411195906e-08 -0.09994749727298403 -2.7137000000000002 0.7070146635164694 0.707013317882545 -8.947056201989712e-08 -0.0999475132181497 -2.7138 0.707014691191667 0.7070133465723007 -9.020575751812754e-08 -0.09994752915847405 -2.7139 0.7070147188505477 0.7070133752612578 -9.092986132108738e-08 -0.09994754509395858 -2.714 0.7070147464932346 0.7070134039492978 -9.164270973940208e-08 -0.09994756102460473 -2.7141 0.7070147741198534 0.7070134326363007 -9.234414173695665e-08 -0.099947576950414 -2.7142000000000004 0.7070148017305312 0.7070134613221437 -9.303399895084496e-08 -0.0999475928713878 -2.7143 0.707014829325397 0.7070134900067037 -9.371212574080939e-08 -0.09994760878752765 -2.7144 0.7070148569045813 0.7070135186898552 -9.437836922220055e-08 -0.09994762469883496 -2.7145 0.7070148844682165 0.7070135473714716 -9.503257929373288e-08 -0.0999476406053113 -2.7146000000000003 0.707014912016436 0.7070135760514242 -9.567460867825062e-08 -0.09994765650695812 -2.7147 0.7070149395493748 0.707013604729583 -9.630431295568759e-08 -0.09994767240377685 -2.7148000000000003 0.7070149670671699 0.7070136334058162 -9.692155059342483e-08 -0.09994768829576889 -2.7149 0.7070149945699595 0.707013662079991 -9.752618296884202e-08 -0.09994770418293579 -2.715 0.7070150220578831 0.7070136907519728 -9.811807442309389e-08 -0.09994772006527897 -2.7151000000000005 0.7070150495310821 0.7070137194216257 -9.869709226804912e-08 -0.09994773594279992 -2.7152000000000003 0.7070150769896986 0.7070137480888123 -9.9263106826189e-08 -0.09994775181550003 -2.7153 0.707015104433877 0.7070137767533942 -9.98159914618324e-08 -0.09994776768338093 -2.7154000000000003 0.7070151318637623 0.7070138054152312 -1.0035562260368724e-07 -0.09994778354644396 -2.7155 0.7070151592795008 0.7070138340741821 -1.0088187978388174e-07 -0.0999477994046906 -2.7156000000000002 0.70701518668124 0.707013862730104 -1.0139464564924011e-07 -0.09994781525812228 -2.7157000000000004 0.707015214069129 0.7070138913828538 -1.0189380599510967e-07 -0.09994783110674052 -2.7158 0.7070152414433178 0.7070139200322858 -1.0237924979311641e-07 -0.0999478469505467 -2.7159 0.7070152688039582 0.7070139486782546 -1.02850869210247e-07 -0.09994786278954239 -2.716 0.7070152961512017 0.7070139773206126 -1.0330855963660429e-07 -0.09994787862372893 -2.7161000000000004 0.7070153234852028 0.7070140059592116 -1.0375221970448933e-07 -0.09994789445310792 -2.7162 0.7070153508061152 0.7070140345939024 -1.0418175131962637e-07 -0.09994791027768074 -2.7163000000000004 0.7070153781140948 0.7070140632245346 -1.0459705967590799e-07 -0.09994792609744886 -2.7164 0.7070154054092979 0.7070140918509564 -1.04998053271875e-07 -0.09994794191241368 -2.7165 0.707015432691882 0.707014120473016 -1.0538464394367619e-07 -0.09994795772257675 -2.7166000000000006 0.7070154599620055 0.70701414909056 -1.0575674687113984e-07 -0.09994797352793948 -2.7167000000000003 0.7070154872198278 0.7070141777034344 -1.061142806055293e-07 -0.0999479893285033 -2.7168 0.7070155144655086 0.7070142063114844 -1.0645716708255343e-07 -0.09994800512426973 -2.7169 0.7070155416992088 0.7070142349145543 -1.0678533163711174e-07 -0.09994802091524022 -2.717 0.7070155689210903 0.7070142635124876 -1.0709870303104996e-07 -0.09994803670141619 -2.7171000000000003 0.7070155961313151 0.707014292105127 -1.0739721345489478e-07 -0.09994805248279912 -2.7172 0.7070156233300463 0.7070143206923148 -1.0768079854953788e-07 -0.09994806825939041 -2.7173000000000003 0.7070156505174475 0.7070143492738924 -1.0794939742011372e-07 -0.09994808403119157 -2.7174 0.7070156776936829 0.7070143778497007 -1.0820295264814261e-07 -0.09994809979820402 -2.7175 0.7070157048589176 0.7070144064195798 -1.0844141029933696e-07 -0.09994811556042922 -2.7176000000000005 0.7070157320133169 0.7070144349833698 -1.0866471993574434e-07 -0.09994813131786867 -2.7177000000000002 0.7070157591570466 0.70701446354091 -1.0887283464003361e-07 -0.0999481470705238 -2.7178 0.7070157862902731 0.707014492092039 -1.0906571100768869e-07 -0.09994816281839604 -2.7179 0.7070158134131628 0.7070145206365952 -1.0924330916782521e-07 -0.0999481785614868 -2.718 0.7070158405258832 0.7070145491744164 -1.0940559277798634e-07 -0.09994819429979761 -2.7181 0.7070158676286018 0.7070145777053407 -1.0955252905189838e-07 -0.0999482100333299 -2.7182000000000004 0.7070158947214862 0.7070146062292052 -1.0968408874038882e-07 -0.09994822576208509 -2.7183 0.7070159218047047 0.7070146347458468 -1.0980024615914186e-07 -0.09994824148606465 -2.7184 0.7070159488784256 0.7070146632551024 -1.0990097918002484e-07 -0.09994825720527005 -2.7185 0.707015975942817 0.7070146917568091 -1.0998626924496602e-07 -0.09994827291970271 -2.7186000000000003 0.7070160029980477 0.7070147202508029 -1.1005610136595456e-07 -0.09994828862936408 -2.7187 0.7070160300442865 0.7070147487369205 -1.1011046411636694e-07 -0.09994830433425561 -2.7188000000000003 0.7070160570817021 0.707014777214998 -1.1014934965004886e-07 -0.09994832003437876 -2.7189 0.7070160841104636 0.7070148056848716 -1.1017275368570278e-07 -0.09994833572973498 -2.719 0.7070161111307398 0.7070148341463777 -1.1018067553290878e-07 -0.09994835142032571 -2.7191000000000005 0.7070161381426994 0.7070148625993524 -1.1017311805396057e-07 -0.09994836710615237 -2.7192000000000003 0.7070161651465114 0.7070148910436322 -1.1015008768641699e-07 -0.09994838278721646 -2.7193 0.7070161921423441 0.7070149194790538 -1.1011159443269358e-07 -0.09994839846351938 -2.7194000000000003 0.7070162191303663 0.7070149479054535 -1.1005765187394045e-07 -0.09994841413506263 -2.7195 0.7070162461107461 0.7070149763226681 -1.0998827713534776e-07 -0.09994842980184757 -2.7196000000000002 0.7070162730836516 0.7070150047305347 -1.0990349090869711e-07 -0.09994844546387568 -2.7197000000000005 0.7070163000492505 0.7070150331288907 -1.0980331742807548e-07 -0.09994846112114841 -2.7198 0.7070163270077106 0.7070150615175734 -1.0968778446814043e-07 -0.09994847677366718 -2.7199 0.7070163539591985 0.7070150898964211 -1.095569233475896e-07 -0.09994849242143344 -2.72 0.7070163809038816 0.707015118265272 -1.0941076889793566e-07 -0.09994850806444867 -2.7201000000000004 0.7070164078419261 0.7070151466239649 -1.0924935948432302e-07 -0.09994852370271433 -2.7202 0.7070164347734977 0.7070151749723392 -1.0907273696909858e-07 -0.0999485393362318 -2.7203000000000004 0.7070164616987618 0.7070152033102342 -1.0888094671528126e-07 -0.09994855496500252 -2.7204 0.7070164886178836 0.7070152316374904 -1.0867403757615357e-07 -0.09994857058902801 -2.7205 0.7070165155310268 0.7070152599539483 -1.0845206186403666e-07 -0.0999485862083096 -2.7206000000000006 0.7070165424383557 0.7070152882594496 -1.0821507536416808e-07 -0.09994860182284877 -2.7207000000000003 0.7070165693400329 0.7070153165538362 -1.079631373086809e-07 -0.09994861743264696 -2.7208 0.7070165962362212 0.7070153448369509 -1.0769631035231764e-07 -0.0999486330377057 -2.7209 0.7070166231270818 0.707015373108637 -1.0741466056635868e-07 -0.09994864863802629 -2.721 0.7070166500127761 0.707015401368739 -1.0711825742821396e-07 -0.09994866423361028 -2.7211000000000003 0.7070166768934638 0.7070154296171014 -1.0680717379453475e-07 -0.09994867982445899 -2.7212 0.7070167037693045 0.7070154578535702 -1.064814858864685e-07 -0.09994869541057395 -2.7213000000000003 0.7070167306404562 0.707015486077992 -1.0614127327144424e-07 -0.09994871099195651 -2.7214 0.7070167575070768 0.7070155142902145 -1.0578661885016216e-07 -0.09994872656860823 -2.7215 0.7070167843693227 0.707015542490086 -1.0541760881669499e-07 -0.09994874214053043 -2.7216000000000005 0.7070168112273496 0.7070155706774562 -1.0503433266022266e-07 -0.0999487577077246 -2.7217000000000002 0.7070168380813124 0.7070155988521755 -1.046368831286032e-07 -0.09994877327019223 -2.7218 0.7070168649313645 0.7070156270140953 -1.042253562179643e-07 -0.09994878882793468 -2.7219 0.7070168917776583 0.707015655163068 -1.0379985113800894e-07 -0.09994880438095337 -2.722 0.707016918620345 0.7070156832989474 -1.0336047029900486e-07 -0.09994881992924977 -2.7221 0.7070169454595753 0.707015711421588 -1.0290731927275337e-07 -0.09994883547282525 -2.7222000000000004 0.7070169722954984 0.7070157395308464 -1.0244050678218097e-07 -0.09994885101168138 -2.7223 0.7070169991282615 0.7070157676265791 -1.019601446640428e-07 -0.09994886654581941 -2.7224 0.7070170259580122 0.707015795708645 -1.014663478533101e-07 -0.09994888207524097 -2.7225 0.707017052784895 0.7070158237769038 -1.0095923434153692e-07 -0.09994889759994735 -2.7226000000000004 0.7070170796090546 0.7070158518312162 -1.0043892516731906e-07 -0.09994891311994003 -2.7227 0.7070171064306333 0.7070158798714444 -9.990554437032395e-08 -0.09994892863522042 -2.7228000000000003 0.7070171332497728 0.7070159078974525 -9.935921896873923e-08 -0.09994894414578996 -2.7229 0.7070171600666127 0.7070159359091055 -9.880007892718035e-08 -0.09994895965165009 -2.723 0.707017186881292 0.7070159639062696 -9.822825713066974e-08 -0.09994897515280224 -2.7231000000000005 0.7070172136939473 0.7070159918888133 -9.764388934734025e-08 -0.09994899064924782 -2.7232000000000003 0.7070172405047146 0.7070160198566059 -9.704711419374068e-08 -0.09994900614098833 -2.7233 0.7070172673137276 0.7070160478095183 -9.643807311922326e-08 -0.0999490216280251 -2.7234000000000003 0.707017294121119 0.7070160757474231 -9.58169103504325e-08 -0.0999490371103596 -2.7235 0.7070173209270195 0.7070161036701944 -9.518377287135588e-08 -0.09994905258799325 -2.7236000000000002 0.7070173477315587 0.7070161315777079 -9.453881037995576e-08 -0.09994906806092747 -2.7237000000000005 0.7070173745348637 0.707016159469841 -9.388217525694437e-08 -0.09994908352916367 -2.7238 0.707017401337061 0.7070161873464729 -9.321402253802819e-08 -0.09994909899270332 -2.7239 0.7070174281382746 0.7070162152074841 -9.25345098592642e-08 -0.09994911445154779 -2.724 0.7070174549386274 0.7070162430527578 -9.184379743017168e-08 -0.09994912990569861 -2.7241000000000004 0.70701748173824 0.7070162708821773 -9.114204800250714e-08 -0.09994914535515709 -2.7242 0.7070175085372312 0.7070162986956292 -9.042942681648791e-08 -0.09994916079992472 -2.7243000000000004 0.7070175353357186 0.7070163264930011 -8.97061015799755e-08 -0.09994917624000291 -2.7244 0.7070175621338174 0.7070163542741826 -8.897224241383173e-08 -0.09994919167539304 -2.7245 0.7070175889316408 0.7070163820390652 -8.822802181895906e-08 -0.09994920710609653 -2.7246000000000006 0.7070176157293011 0.7070164097875425 -8.747361462859565e-08 -0.0999492225321149 -2.7247000000000003 0.7070176425269077 0.7070164375195098 -8.670919797882509e-08 -0.09994923795344951 -2.7248 0.7070176693245684 0.7070164652348643 -8.593495126087147e-08 -0.0999492533701018 -2.7249 0.7070176961223891 0.7070164929335051 -8.515105608206813e-08 -0.09994926878207318 -2.725 0.7070177229204735 0.7070165206153334 -8.435769621381595e-08 -0.09994928418936505 -2.7251000000000003 0.7070177497189235 0.7070165482802521 -8.355505755862358e-08 -0.09994929959197882 -2.7252 0.7070177765178391 0.7070165759281665 -8.274332810500468e-08 -0.09994931498991594 -2.7253000000000003 0.7070178033173182 0.7070166035589839 -8.192269788324241e-08 -0.09994933038317781 -2.7254 0.7070178301174563 0.7070166311726136 -8.109335891334779e-08 -0.09994934577176588 -2.7255 0.707017856918347 0.707016658768967 -8.025550517036517e-08 -0.09994936115568154 -2.7256000000000005 0.707017883720082 0.7070166863479579 -7.940933252972848e-08 -0.09994937653492626 -2.7257000000000002 0.7070179105227508 0.7070167139095012 -7.855503873690356e-08 -0.09994939190950142 -2.7258 0.7070179373264405 0.7070167414535149 -7.769282333973393e-08 -0.09994940727940839 -2.7259 0.7070179641312361 0.7070167689799192 -7.682288766241996e-08 -0.09994942264464864 -2.726 0.7070179909372207 0.7070167964886358 -7.594543474393617e-08 -0.0999494380052236 -2.7261 0.7070180177444749 0.7070168239795893 -7.506066929466315e-08 -0.09994945336113462 -2.7262000000000004 0.7070180445530773 0.7070168514527062 -7.41687976547542e-08 -0.09994946871238317 -2.7263 0.707018071363104 0.707016878907915 -7.32700277381905e-08 -0.09994948405897064 -2.7264 0.707018098174629 0.707016906345147 -7.236456898507618e-08 -0.09994949940089848 -2.7265 0.7070181249877243 0.7070169337643355 -7.145263232173973e-08 -0.09994951473816811 -2.7266000000000004 0.707018151802459 0.7070169611654158 -7.053443010045235e-08 -0.09994953007078089 -2.7267 0.7070181786189005 0.7070169885483257 -6.961017605562614e-08 -0.09994954539873825 -2.7268000000000003 0.7070182054371135 0.7070170159130056 -6.868008525350716e-08 -0.0999495607220416 -2.7269 0.7070182322571605 0.7070170432593981 -6.774437404056741e-08 -0.09994957604069239 -2.727 0.7070182590791019 0.7070170705874477 -6.68032599931978e-08 -0.09994959135469199 -2.7271000000000005 0.707018285902995 0.7070170978971017 -6.585696187217174e-08 -0.09994960666404179 -2.7272000000000003 0.7070183127288958 0.7070171251883098 -6.490569956192974e-08 -0.09994962196874335 -2.7273 0.7070183395568571 0.7070171524610238 -6.394969403154815e-08 -0.09994963726879791 -2.7274000000000003 0.7070183663869296 0.7070171797151977 -6.29891672740239e-08 -0.0999496525642069 -2.7275 0.7070183932191614 0.7070172069507886 -6.20243422611716e-08 -0.09994966785497174 -2.7276000000000002 0.7070184200535987 0.7070172341677555 -6.105544288377562e-08 -0.09994968314109391 -2.7277000000000005 0.7070184468902847 0.7070172613660599 -6.008269391039045e-08 -0.09994969842257476 -2.7278000000000002 0.7070184737292609 0.7070172885456658 -5.910632092489057e-08 -0.09994971369941573 -2.7279 0.7070185005705654 0.7070173157065395 -5.812655028201823e-08 -0.09994972897161819 -2.728 0.7070185274142348 0.7070173428486499 -5.714360904883649e-08 -0.09994974423918362 -2.7281000000000004 0.7070185542603022 0.7070173699719682 -5.6157724957458036e-08 -0.09994975950211336 -2.7282 0.7070185811087997 0.7070173970764683 -5.516912634801613e-08 -0.09994977476040887 -2.7283000000000004 0.7070186079597554 0.7070174241621259 -5.4178042118574465e-08 -0.09994979001407148 -2.7284 0.7070186348131959 0.70701745122892 -5.3184701672001275e-08 -0.09994980526310264 -2.7285 0.7070186616691452 0.7070174782768315 -5.218933486110869e-08 -0.09994982050750373 -2.7286000000000006 0.7070186885276242 0.7070175053058443 -5.1192171937044714e-08 -0.0999498357472762 -2.7287000000000003 0.7070187153886522 0.7070175323159442 -5.019344349399893e-08 -0.0999498509824214 -2.7288 0.7070187422522456 0.70701755930712 -4.919338041976286e-08 -0.09994986621294079 -2.7289 0.7070187691184184 0.7070175862793623 -4.8192213836857796e-08 -0.09994988143883575 -2.729 0.7070187959871821 0.7070176132326651 -4.7190175056456216e-08 -0.09994989666010774 -2.7291000000000003 0.7070188228585452 0.7070176401670241 -4.618749551837118e-08 -0.09994991187675806 -2.7292 0.7070188497325147 0.707017667082438 -4.51844067393941e-08 -0.09994992708878819 -2.7293000000000003 0.7070188766090943 0.7070176939789072 -4.41811402620933e-08 -0.09994994229619943 -2.7294 0.7070189034882859 0.7070177208564359 -4.317792759859812e-08 -0.09994995749899332 -2.7295 0.707018930370088 0.7070177477150292 -4.2175000177893164e-08 -0.09994997269717115 -2.7296000000000005 0.7070189572544976 0.7070177745546962 -4.1172589295606146e-08 -0.09994998789073439 -2.7297000000000002 0.7070189841415087 0.7070178013754475 -4.017092605481049e-08 -0.09995000307968445 -2.7298 0.7070190110311128 0.7070178281772967 -3.9170241319594346e-08 -0.09995001826402272 -2.7299 0.7070190379232986 0.7070178549602594 -3.8170765655036465e-08 -0.0999500334437505 -2.73 0.7070190648180533 0.707017881724354 -3.71727292787288e-08 -0.09995004861886932 -2.7301 0.7070190917153606 0.7070179084696013 -3.6176362007162705e-08 -0.09995006378938048 -2.7302000000000004 0.7070191186152024 0.7070179351960246 -3.5181893199729905e-08 -0.09995007895528543 -2.7303 0.707019145517558 0.7070179619036495 -3.418955171101759e-08 -0.09995009411658554 -2.7304 0.7070191724224042 0.7070179885925043 -3.319956583410465e-08 -0.09995010927328225 -2.7305 0.7070191993297151 0.7070180152626198 -3.221216324906205e-08 -0.09995012442537694 -2.7306000000000004 0.707019226239463 0.7070180419140286 -3.1227570970477486e-08 -0.09995013957287105 -2.7307 0.707019253151617 0.7070180685467664 -3.0246015297582043e-08 -0.09995015471576588 -2.7308000000000003 0.7070192800661441 0.707018095160871 -2.926772175895591e-08 -0.09995016985406288 -2.7309 0.7070193069830092 0.7070181217563827 -2.8292915062871904e-08 -0.0999501849877634 -2.731 0.7070193339021745 0.7070181483333442 -2.732181904330222e-08 -0.0999502001168689 -2.7311000000000005 0.7070193608235997 0.7070181748918006 -2.6354656613514563e-08 -0.09995021524138073 -2.7312000000000003 0.7070193877472424 0.7070182014317996 -2.539164970991048e-08 -0.09995023036130032 -2.7313 0.7070194146730576 0.7070182279533908 -2.4433019241935222e-08 -0.09995024547662905 -2.7314000000000003 0.707019441600998 0.7070182544566266 -2.3478985043505485e-08 -0.09995026058736832 -2.7315 0.707019468531014 0.7070182809415614 -2.2529765822485587e-08 -0.0999502756935195 -2.7316000000000003 0.7070194954630536 0.7070183074082521 -2.1585579107561564e-08 -0.09995029079508398 -2.7317000000000005 0.7070195223970626 0.707018333856758 -2.0646641199235233e-08 -0.09995030589206319 -2.7318000000000002 0.7070195493329843 0.7070183602871405 -1.971316712602242e-08 -0.09995032098445847 -2.7319 0.7070195762707597 0.7070183866994635 -1.8785370587207084e-08 -0.09995033607227123 -2.732 0.707019603210328 0.7070184130937931 -1.7863463906871158e-08 -0.09995035115550291 -2.7321000000000004 0.7070196301516254 0.7070184394701977 -1.6947657989659082e-08 -0.09995036623415483 -2.7322 0.7070196570945865 0.7070184658287476 -1.6038162266134026e-08 -0.09995038130822842 -2.7323000000000004 0.7070196840391432 0.707018492169516 -1.5135184646807714e-08 -0.09995039637772507 -2.7324 0.7070197109852255 0.7070185184925777 -1.4238931477904976e-08 -0.09995041144264614 -2.7325 0.707019737932761 0.70701854479801 -1.3349607487587317e-08 -0.09995042650299304 -2.7326000000000006 0.7070197648816754 0.7070185710858922 -1.2467415747789007e-08 -0.09995044155876717 -2.7327000000000004 0.7070197918318916 0.7070185973563059 -1.159255762217537e-08 -0.09995045660996986 -2.7328 0.7070198187833312 0.707018623609335 -1.0725232720172617e-08 -0.09995047165660255 -2.7329 0.7070198457359131 0.7070186498450652 -9.86563885533448e-09 -0.09995048669866664 -2.733 0.707019872689554 0.7070186760635848 -9.013971993300507e-09 -0.09995050173616349 -2.7331000000000003 0.7070198996441694 0.7070187022649834 -8.170426213198467e-09 -0.09995051676909451 -2.7332 0.7070199265996719 0.707018728449353 -7.335193663408901e-09 -0.09995053179746105 -2.7333000000000003 0.707019953555972 0.707018754616788 -6.5084645121255e-09 -0.09995054682126453 -2.7334 0.7070199805129787 0.7070187807673842 -5.690426916130087e-09 -0.09995056184050626 -2.7335 0.7070200074705986 0.7070188069012401 -4.881266963546738e-09 -0.09995057685518768 -2.7336000000000005 0.7070200344287365 0.7070188330184555 -4.081168640014676e-09 -0.09995059186531019 -2.7337000000000002 0.7070200613872959 0.7070188591191329 -3.2903137827181017e-09 -0.09995060687087519 -2.7338 0.7070200883461768 0.7070188852033759 -2.5088820422222713e-09 -0.09995062187188404 -2.7339 0.7070201153052789 0.7070189112712902 -1.7370508408401375e-09 -0.0999506368683381 -2.734 0.7070201422644988 0.7070189373229837 -9.749953336010697e-10 -0.09995065186023872 -2.7341 0.7070201692237323 0.7070189633585662 -2.2288836401540557e-10 -0.09995066684758735 -2.7342000000000004 0.7070201961828725 0.7070189893781489 5.190995714873803e-10 -0.09995068183038536 -2.7343 0.707020223141811 0.7070190153818452 1.2508003582531457e-09 -0.09995069680863411 -2.7344 0.7070202501004377 0.7070190413697699 1.9720483111079767e-09 -0.09995071178233492 -2.7345 0.7070202770586411 0.7070190673420402 2.682680202113763e-09 -0.09995072675148933 -2.7346000000000004 0.7070203040163074 0.7070190932987741 3.3825353048036466e-09 -0.09995074171609862 -2.7347 0.7070203309733212 0.7070191192400921 4.071455430611215e-09 -0.09995075667616418 -2.7348000000000003 0.7070203579295655 0.7070191451661156 4.7492849566260764e-09 -0.09995077163168736 -2.7349 0.7070203848849221 0.7070191710769687 5.415870868961947e-09 -0.09995078658266959 -2.735 0.7070204118392703 0.7070191969727758 6.071062790512227e-09 -0.09995080152911223 -2.7351000000000005 0.7070204387924887 0.7070192228536641 6.714713024318086e-09 -0.09995081647101665 -2.7352000000000003 0.7070204657444537 0.7070192487197615 7.346676575252509e-09 -0.0999508314083842 -2.7353 0.7070204926950403 0.7070192745711981 7.966811191653655e-09 -0.09995084634121634 -2.7354000000000003 0.7070205196441226 0.7070193004081046 8.574977390478355e-09 -0.09995086126951436 -2.7355 0.7070205465915724 0.7070193262306141 9.171038496333384e-09 -0.09995087619327968 -2.7356000000000003 0.7070205735372606 0.7070193520388608 9.754860667496312e-09 -0.09995089111251367 -2.7357000000000005 0.7070206004810564 0.7070193778329799 1.0326312923671088e-08 -0.0999509060272177 -2.7358000000000002 0.7070206274228279 0.7070194036131083 1.0885267183284586e-08 -0.09995092093739312 -2.7359 0.7070206543624414 0.7070194293793846 1.1431598276497035e-08 -0.09995093584304134 -2.736 0.7070206812997628 0.707019455131948 1.1965183995508999e-08 -0.09995095074416371 -2.7361000000000004 0.7070207082346558 0.7070194808709395 1.248590510063291e-08 -0.09995096564076164 -2.7362 0.707020735166983 0.7070195065965011 1.299364536626324e-08 -0.09995098053283646 -2.7363000000000004 0.7070207620966064 0.7070195323087762 1.3488291586948031e-08 -0.09995099542038959 -2.7364 0.7070207890233859 0.707019558007909 1.3969733619022262e-08 -0.09995101030342235 -2.7365 0.7070208159471812 0.7070195836940454 1.4437864398822442e-08 -0.09995102518193615 -2.7366 0.7070208428678504 0.7070196093673318 1.48925799565644e-08 -0.0999510400559323 -2.7367000000000004 0.7070208697852502 0.7070196350279161 1.5333779464915542e-08 -0.09995105492541226 -2.7368 0.7070208966992373 0.7070196606759473 1.576136522858651e-08 -0.09995106979037738 -2.7369 0.7070209236096657 0.7070196863115749 1.6175242734638162e-08 -0.09995108465082891 -2.737 0.7070209505163905 0.7070197119349502 1.657532065074685e-08 -0.09995109950676842 -2.7371000000000003 0.707020977419264 0.7070197375462245 1.696151086683778e-08 -0.09995111435819712 -2.7372 0.7070210043181389 0.7070197631455506 1.733372850028919e-08 -0.09995112920511648 -2.7373000000000003 0.7070210312128663 0.7070197887330819 1.7691891917616387e-08 -0.09995114404752779 -2.7374 0.7070210581032967 0.7070198143089731 1.8035922750084254e-08 -0.0999511588854325 -2.7375 0.7070210849892795 0.7070198398733792 1.8365745914523945e-08 -0.09995117371883189 -2.7376000000000005 0.7070211118706642 0.7070198654264561 1.868128963068011e-08 -0.09995118854772739 -2.7377000000000002 0.7070211387472983 0.7070198909683604 1.8982485428149787e-08 -0.09995120337212031 -2.7378 0.70702116561903 0.7070199164992496 1.9269268172403264e-08 -0.0999512181920121 -2.7379000000000002 0.7070211924857056 0.7070199420192815 1.9541576071722966e-08 -0.09995123300740405 -2.738 0.7070212193471718 0.7070199675286151 1.979935069628541e-08 -0.09995124781829763 -2.7381 0.7070212462032737 0.707019993027409 2.004253698423275e-08 -0.09995126262469409 -2.7382000000000004 0.7070212730538563 0.7070200185158237 2.027108325641791e-08 -0.09995127742659482 -2.7383 0.7070212998987646 0.7070200439940187 2.0484941226812936e-08 -0.09995129222400118 -2.7384 0.7070213267378422 0.7070200694621553 2.068406601031525e-08 -0.09995130701691453 -2.7385 0.7070213535709332 0.7070200949203944 2.0868416138360157e-08 -0.09995132180533627 -2.7386000000000004 0.7070213803978806 0.7070201203688979 2.1037953561522937e-08 -0.09995133658926778 -2.7387 0.7070214072185275 0.7070201458078277 2.1192643659059818e-08 -0.0999513513687104 -2.7388000000000003 0.7070214340327161 0.7070201712373461 2.1332455246714233e-08 -0.09995136614366551 -2.7389 0.7070214608402887 0.7070201966576153 2.1457360583655716e-08 -0.09995138091413441 -2.739 0.7070214876410874 0.7070202220687983 2.1567335375949348e-08 -0.09995139568011849 -2.7391000000000005 0.707021514434954 0.7070202474710583 2.166235877742312e-08 -0.09995141044161912 -2.7392000000000003 0.70702154122173 0.7070202728645585 2.174241340701516e-08 -0.09995142519863767 -2.7393 0.7070215680012566 0.7070202982494622 2.180748533055915e-08 -0.09995143995117549 -2.7394000000000003 0.7070215947733753 0.7070203236259329 2.1857564081601e-08 -0.09995145469923389 -2.7395 0.7070216215379279 0.7070203489941344 2.18926426509905e-08 -0.09995146944281436 -2.7396000000000003 0.7070216482947547 0.7070203743542298 2.1912717500759127e-08 -0.09995148418191813 -2.7397000000000005 0.7070216750436976 0.7070203997063831 2.1917788551109596e-08 -0.09995149891654663 -2.7398000000000002 0.7070217017845976 0.7070204250507575 2.1907859182150602e-08 -0.09995151364670117 -2.7399 0.7070217285172962 0.7070204503875166 2.1882936236498896e-08 -0.09995152837238312 -2.74 0.7070217552416348 0.7070204757168236 2.184303001060567e-08 -0.09995154309359389 -2.7401000000000004 0.7070217819574551 0.707020501038842 2.1788154259093362e-08 -0.09995155781033477 -2.7402 0.7070218086645985 0.7070205263537344 2.1718326180010517e-08 -0.09995157252260711 -2.7403000000000004 0.7070218353629075 0.7070205516616639 2.1633566416566496e-08 -0.09995158723041234 -2.7404 0.7070218620522244 0.7070205769627929 2.153389905279468e-08 -0.0999516019337518 -2.7405 0.7070218887323916 0.7070206022572834 2.1419351610083015e-08 -0.09995161663262679 -2.7406 0.707021915403252 0.7070206275452974 2.1289955026357332e-08 -0.09995163132703867 -2.7407000000000004 0.7070219420646492 0.7070206528269964 2.114574366041816e-08 -0.09995164601698887 -2.7408 0.7070219687164265 0.7070206781025415 2.0986755271991397e-08 -0.09995166070247868 -2.7409 0.7070219953584285 0.7070207033720932 2.0813031026065132e-08 -0.09995167538350946 -2.741 0.7070220219904996 0.7070207286358117 2.0624615474675034e-08 -0.09995169006008256 -2.7411000000000003 0.7070220486124852 0.7070207538938567 2.0421556537822405e-08 -0.09995170473219939 -2.7412 0.7070220752242308 0.707020779146387 2.0203905508678344e-08 -0.09995171939986124 -2.7413000000000003 0.7070221018255828 0.7070208043935613 1.9971717025828173e-08 -0.09995173406306947 -2.7414 0.7070221284163883 0.7070208296355371 1.9725049067199907e-08 -0.09995174872182545 -2.7415 0.7070221549964946 0.7070208548724719 1.9463962932717016e-08 -0.09995176337613049 -2.7416000000000005 0.7070221815657503 0.707020880104522 1.9188523231288e-08 -0.09995177802598598 -2.7417000000000002 0.7070222081240042 0.707020905331843 1.889879785825499e-08 -0.09995179267139322 -2.7418 0.7070222346711064 0.7070209305545903 1.8594857996261094e-08 -0.09995180731235366 -2.7419000000000002 0.707022261206907 0.7070209557729177 1.8276778074484412e-08 -0.09995182194886852 -2.742 0.7070222877312581 0.7070209809869786 1.7944635763433858e-08 -0.09995183658093929 -2.7421 0.7070223142440117 0.7070210061969255 1.7598511956734564e-08 -0.09995185120856724 -2.7422000000000004 0.7070223407450213 0.7070210314029101 1.7238490748576474e-08 -0.09995186583175375 -2.7423 0.7070223672341408 0.7070210566050826 1.686465941636711e-08 -0.09995188045050013 -2.7424 0.7070223937112255 0.7070210818035929 1.647710839557809e-08 -0.09995189506480777 -2.7425 0.7070224201761316 0.7070211069985892 1.6075931256326337e-08 -0.09995190967467794 -2.7426000000000004 0.707022446628716 0.7070211321902193 1.5661224686026876e-08 -0.09995192428011204 -2.7427 0.7070224730688371 0.7070211573786298 1.5233088468576128e-08 -0.09995193888111138 -2.7428000000000003 0.7070224994963548 0.7070211825639658 1.4791625444453282e-08 -0.0999519534776774 -2.7429 0.7070225259111291 0.707021207746372 1.433694150985293e-08 -0.09995196806981141 -2.743 0.7070225523130218 0.7070212329259911 1.3869145571582253e-08 -0.09995198265751469 -2.7431000000000005 0.7070225787018962 0.7070212581029649 1.3388349538387412e-08 -0.09995199724078868 -2.7432000000000003 0.707022605077616 0.7070212832774339 1.2894668268044474e-08 -0.09995201181963462 -2.7433 0.7070226314400467 0.7070213084495375 1.23882195699615e-08 -0.0999520263940539 -2.7434000000000003 0.7070226577890553 0.7070213336194138 1.1869124154871569e-08 -0.09995204096404786 -2.7435 0.7070226841245093 0.7070213587871995 1.1337505618352894e-08 -0.09995205552961783 -2.7436000000000003 0.7070227104462787 0.7070213839530297 1.0793490410471174e-08 -0.09995207009076514 -2.7437000000000005 0.7070227367542342 0.7070214091170388 1.023720779414622e-08 -0.09995208464749124 -2.7438000000000002 0.707022763048248 0.7070214342793592 9.668789838213065e-09 -0.0999520991997974 -2.7439 0.7070227893281937 0.7070214594401216 9.088371354971925e-09 -0.09995211374768494 -2.744 0.7070228155939464 0.707021484599456 8.496089890647207e-09 -0.09995212829115524 -2.7441000000000004 0.7070228418453832 0.7070215097574901 7.892085692427775e-09 -0.09995214283020962 -2.7442 0.7070228680823817 0.7070215349143505 7.276501665098856e-09 -0.09995215736484937 -2.7443 0.7070228943048222 0.7070215600701624 6.6494833363475725e-09 -0.09995217189507594 -2.7444 0.7070229205125858 0.7070215852250483 6.011178834211539e-09 -0.0999521864208905 -2.7445 0.7070229467055558 0.7070216103791311 5.361738840241326e-09 -0.09995220094229462 -2.7446 0.7070229728836166 0.7070216355325305 4.701316565214331e-09 -0.09995221545928949 -2.7447000000000004 0.7070229990466547 0.7070216606853645 4.030067705766693e-09 -0.09995222997187647 -2.7448 0.707023025194558 0.70702168583775 3.348150407964101e-09 -0.09995224448005689 -2.7449 0.7070230513272162 0.7070217109898023 2.6557252317399582e-09 -0.09995225898383212 -2.745 0.7070230774445208 0.707021736141634 1.9529551118641075e-09 -0.09995227348320342 -2.7451000000000003 0.7070231035463651 0.707021761293357 1.2400053223809993e-09 -0.09995228797817218 -2.7452 0.7070231296326445 0.707021786445081 5.170434297721571e-10 -0.09995230246873978 -2.7453000000000003 0.7070231557032556 0.7070218115969131 -2.157607304625886e-10 -0.09995231695490746 -2.7454 0.7070231817580973 0.7070218367489601 -9.582351162551461e-10 -0.09995233143667664 -2.7455 0.7070232077970702 0.7070218619013259 -1.710205496316397e-09 -0.09995234591404864 -2.7456000000000005 0.707023233820077 0.7070218870541125 -2.4714955030452623e-09 -0.0999523603870248 -2.7457000000000003 0.707023259827022 0.70702191220742 -3.241926679366236e-09 -0.0999523748556064 -2.7458 0.7070232858178118 0.7070219373613469 -4.021318503015514e-09 -0.09995238931979483 -2.7459000000000002 0.7070233117923546 0.7070219625159894 -4.809488443786869e-09 -0.09995240377959136 -2.746 0.7070233377505608 0.7070219876714419 -5.606252005165013e-09 -0.09995241823499741 -2.7461 0.7070233636923426 0.7070220128277969 -6.4114227607547924e-09 -0.0999524326860142 -2.7462000000000004 0.7070233896176148 0.7070220379851443 -7.2248124019860804e-09 -0.09995244713264313 -2.7463 0.7070234155262936 0.7070220631435729 -8.046230780614505e-09 -0.09995246157488556 -2.7464 0.7070234414182974 0.707022088303169 -8.875485952956896e-09 -0.09995247601274286 -2.7465 0.7070234672935469 0.7070221134640164 -9.712384224994097e-09 -0.09995249044621625 -2.7466000000000004 0.7070234931519648 0.7070221386261972 -1.0556730201810582e-08 -0.0999525048753071 -2.7467 0.7070235189934758 0.7070221637897913 -1.1408326824023651e-08 -0.09995251930001674 -2.7468000000000004 0.7070235448180069 0.7070221889548762 -1.2266975425029303e-08 -0.09995253372034649 -2.7469 0.707023570625487 0.7070222141215281 -1.3132475770033514e-08 -0.0999525481362977 -2.747 0.7070235964158474 0.70702223928982 -1.4004626100721368e-08 -0.09995256254787167 -2.7471000000000005 0.707023622189022 0.7070222644598233 -1.4883223189033484e-08 -0.09995257695506979 -2.7472000000000003 0.7070236479449461 0.707022289631607 -1.5768062381401465e-08 -0.09995259135789333 -2.7473 0.7070236736835576 0.707022314805238 -1.6658937642983346e-08 -0.09995260575634367 -2.7474000000000003 0.7070236994047963 0.7070223399807807 -1.7555641613608425e-08 -0.09995262015042204 -2.7475 0.707023725108605 0.7070223651582979 -1.8457965647242225e-08 -0.09995263454012987 -2.7476000000000003 0.7070237507949279 0.7070223903378492 -1.93656998661966e-08 -0.0999526489254684 -2.7477000000000005 0.7070237764637122 0.7070224155194929 -2.027863320623255e-08 -0.09995266330643907 -2.7478000000000002 0.7070238021149066 0.7070224407032839 -2.119655347207136e-08 -0.09995267768304304 -2.7479 0.7070238277484628 0.7070224658892762 -2.2119247378594303e-08 -0.09995269205528179 -2.748 0.7070238533643349 0.7070224910775202 -2.304650060678745e-08 -0.09995270642315658 -2.7481000000000004 0.7070238789624784 0.7070225162680651 -2.3978097847109775e-08 -0.09995272078666878 -2.7482 0.7070239045428517 0.707022541460957 -2.4913822855871653e-08 -0.09995273514581965 -2.7483 0.7070239301054158 0.7070225666562394 -2.5853458502072407e-08 -0.0999527495006105 -2.7484 0.7070239556501334 0.7070225918539544 -2.679678681770728e-08 -0.09995276385104272 -2.7485 0.7070239811769699 0.7070226170541412 -2.774358904894178e-08 -0.09995277819711756 -2.7486 0.7070240066858935 0.7070226422568369 -2.8693645708803908e-08 -0.09995279253883643 -2.7487000000000004 0.7070240321768739 0.7070226674620756 -2.964673662445537e-08 -0.09995280687620058 -2.7488 0.7070240576498839 0.7070226926698902 -3.060264098901644e-08 -0.09995282120921142 -2.7489 0.707024083104898 0.7070227178803099 -3.156113741599291e-08 -0.09995283553787018 -2.749 0.7070241085418938 0.7070227430933624 -3.252200398567995e-08 -0.09995284986217827 -2.7491000000000003 0.7070241339608505 0.7070227683090727 -3.348501829915536e-08 -0.09995286418213689 -2.7492 0.7070241593617507 0.7070227935274633 -3.444995753010445e-08 -0.09995287849774744 -2.7493000000000003 0.7070241847445782 0.7070228187485545 -3.541659847642806e-08 -0.0999528928090112 -2.7494 0.7070242101093203 0.7070228439723641 -3.638471760946532e-08 -0.09995290711592952 -2.7495 0.707024235455966 0.7070228691989076 -3.735409112798696e-08 -0.0999529214185037 -2.7496000000000005 0.7070242607845073 0.7070228944281981 -3.8324495010670645e-08 -0.0999529357167351 -2.7497000000000003 0.7070242860949381 0.707022919660246 -3.9295705064239586e-08 -0.09995295001062504 -2.7498 0.7070243113872546 0.7070229448950598 -4.026749697761843e-08 -0.09995296430017477 -2.7499000000000002 0.7070243366614559 0.7070229701326449 -4.123964637440863e-08 -0.09995297858538563 -2.75 0.7070243619175429 0.707022995373005 -4.221192886455071e-08 -0.09995299286625894 -2.7501 0.7070243871555197 0.707023020616141 -4.3184120094604114e-08 -0.09995300714279604 -2.7502000000000004 0.7070244123753922 0.7070230458620512 -4.4155995799260365e-08 -0.09995302141499818 -2.7503 0.707024437577169 0.707023071110732 -4.512733185502464e-08 -0.09995303568286676 -2.7504 0.7070244627608611 0.7070230963621771 -4.609790433076667e-08 -0.09995304994640306 -2.7505 0.7070244879264816 0.707023121616378 -4.706748953987091e-08 -0.0999530642056084 -2.7506000000000004 0.7070245130740465 0.7070231468733235 -4.803586408936439e-08 -0.09995307846048412 -2.7507 0.7070245382035737 0.7070231721330003 -4.9002804936091986e-08 -0.0999530927110315 -2.7508000000000004 0.7070245633150836 0.707023197395392 -4.996808943382499e-08 -0.09995310695725185 -2.7509 0.7070245884085994 0.7070232226604809 -5.093149538519439e-08 -0.0999531211991465 -2.751 0.707024613484146 0.7070232479282463 -5.1892801095684143e-08 -0.09995313543671676 -2.7511000000000005 0.7070246385417512 0.707023273198665 -5.285178542166133e-08 -0.0999531496699639 -2.7512000000000003 0.707024663581445 0.7070232984717119 -5.3808227821767335e-08 -0.09995316389888928 -2.7513 0.7070246886032596 0.7070233237473589 -5.4761908407658516e-08 -0.09995317812349418 -2.7514000000000003 0.7070247136072301 0.7070233490255766 -5.57126079955058e-08 -0.09995319234377999 -2.7515 0.707024738593393 0.7070233743063319 -5.66601081543501e-08 -0.0999532065597479 -2.7516000000000003 0.7070247635617881 0.7070233995895906 -5.760419126052928e-08 -0.09995322077139934 -2.7517000000000005 0.707024788512457 0.7070234248753151 -5.8544640542780926e-08 -0.09995323497873553 -2.7518000000000002 0.7070248134454439 0.7070234501634665 -5.94812401342841e-08 -0.09995324918175785 -2.7519 0.7070248383607949 0.7070234754540026 -6.041377512188209e-08 -0.09995326338046753 -2.752 0.7070248632585586 0.7070235007468797 -6.13420315948715e-08 -0.09995327757486594 -2.7521000000000004 0.7070248881387861 0.7070235260420514 -6.22657966944419e-08 -0.09995329176495435 -2.7522 0.7070249130015306 0.7070235513394693 -6.31848586646333e-08 -0.09995330595073414 -2.7523 0.7070249378468476 0.7070235766390823 -6.409900689353584e-08 -0.09995332013220654 -2.7524 0.7070249626747946 0.7070236019408376 -6.500803197400512e-08 -0.09995333430937291 -2.7525 0.7070249874854317 0.7070236272446797 -6.591172574009138e-08 -0.09995334848223451 -2.7526 0.7070250122788208 0.7070236525505511 -6.680988131778018e-08 -0.09995336265079266 -2.7527000000000004 0.7070250370550264 0.7070236778583923 -6.770229317790144e-08 -0.09995337681504865 -2.7528 0.7070250618141152 0.7070237031681408 -6.85887571738597e-08 -0.09995339097500383 -2.7529 0.7070250865561558 0.7070237284797333 -6.946907059801263e-08 -0.09995340513065953 -2.753 0.7070251112812189 0.7070237537931027 -7.034303221853389e-08 -0.09995341928201695 -2.7531000000000003 0.707025135989378 0.7070237791081813 -7.121044233102114e-08 -0.09995343342907748 -2.7532 0.7070251606807076 0.707023804424898 -7.207110280620099e-08 -0.09995344757184238 -2.7533000000000003 0.7070251853552856 0.7070238297431806 -7.292481712939392e-08 -0.099953461710313 -2.7534 0.7070252100131906 0.7070238550629542 -7.377139045038755e-08 -0.09995347584449057 -2.7535 0.7070252346545047 0.7070238803841419 -7.461062962420273e-08 -0.09995348997437646 -2.7536000000000005 0.7070252592793109 0.7070239057066647 -7.544234325619625e-08 -0.09995350409997192 -2.7537000000000003 0.7070252838876951 0.7070239310304421 -7.626634174542901e-08 -0.09995351822127829 -2.7538 0.7070253084797447 0.7070239563553912 -7.708243732976877e-08 -0.09995353233829687 -2.7539000000000002 0.7070253330555489 0.7070239816814265 -7.789044412492147e-08 -0.09995354645102894 -2.754 0.7070253576151997 0.7070240070084618 -7.869017817300344e-08 -0.09995356055947585 -2.7541 0.7070253821587902 0.7070240323364081 -7.94814574737665e-08 -0.09995357466363888 -2.7542000000000004 0.7070254066864158 0.7070240576651745 -8.026410204444584e-08 -0.09995358876351931 -2.7543 0.7070254311981736 0.7070240829946683 -8.103793393537256e-08 -0.09995360285911845 -2.7544 0.7070254556941631 0.7070241083247951 -8.180277729415847e-08 -0.09995361695043758 -2.7545 0.7070254801744849 0.7070241336554584 -8.255845839171688e-08 -0.099953631037478 -2.7546000000000004 0.7070255046392422 0.7070241589865599 -8.330480566736548e-08 -0.09995364512024102 -2.7547 0.7070255290885394 0.7070241843179994 -8.404164976178602e-08 -0.09995365919872792 -2.7548000000000004 0.7070255535224832 0.7070242096496754 -8.476882356212717e-08 -0.09995367327294004 -2.7549 0.7070255779411818 0.707024234981484 -8.548616223583161e-08 -0.09995368734287868 -2.755 0.707025602344745 0.7070242603133199 -8.619350326966729e-08 -0.09995370140854509 -2.7551000000000005 0.7070256267332848 0.7070242856450762 -8.689068651049348e-08 -0.09995371546994065 -2.7552000000000003 0.7070256511069141 0.7070243109766439 -8.757755419388363e-08 -0.09995372952706655 -2.7553 0.7070256754657481 0.7070243363079126 -8.825395098228939e-08 -0.09995374357992415 -2.7554000000000003 0.7070256998099036 0.70702436163877 -8.89197239988676e-08 -0.0999537576285147 -2.7555 0.7070257241394989 0.7070243869691026 -8.95747228708485e-08 -0.09995377167283954 -2.7556000000000003 0.7070257484546536 0.7070244122987952 -9.021879975382174e-08 -0.09995378571289992 -2.7557000000000005 0.7070257727554894 0.7070244376277308 -9.085180936382886e-08 -0.09995379974869717 -2.7558000000000002 0.7070257970421292 0.7070244629557912 -9.147360901812923e-08 -0.09995381378023263 -2.7559 0.7070258213146975 0.7070244882828565 -9.208405866469038e-08 -0.09995382780750751 -2.756 0.70702584557332 0.7070245136088051 -9.268302091167829e-08 -0.09995384183052315 -2.7561000000000004 0.7070258698181241 0.7070245389335144 -9.327036105521297e-08 -0.09995385584928078 -2.7562 0.7070258940492387 0.7070245642568602 -9.384594711926708e-08 -0.09995386986378176 -2.7563 0.7070259182667935 0.7070245895787168 -9.440964987821737e-08 -0.09995388387402732 -2.7564 0.7070259424709209 0.7070246148989576 -9.496134288633495e-08 -0.09995389788001884 -2.7565 0.7070259666617529 0.7070246402174539 -9.550090250380616e-08 -0.0999539118817575 -2.7566 0.7070259908394241 0.7070246655340766 -9.602820793142702e-08 -0.09995392587924473 -2.7567000000000004 0.7070260150040698 0.7070246908486945 -9.65431412322873e-08 -0.09995393987248172 -2.7568 0.7070260391558265 0.7070247161611758 -9.704558736126079e-08 -0.0999539538614698 -2.7569 0.707026063294832 0.707024741471387 -9.753543418929145e-08 -0.09995396784621022 -2.757 0.7070260874212251 0.7070247667791939 -9.801257252681217e-08 -0.09995398182670426 -2.7571000000000003 0.7070261115351464 0.707024792084461 -9.847689615150035e-08 -0.09995399580295329 -2.7572 0.7070261356367367 0.707024817387051 -9.892830182302303e-08 -0.09995400977495848 -2.7573000000000003 0.7070261597261386 0.7070248426868271 -9.936668932293558e-08 -0.09995402374272126 -2.7574 0.7070261838034952 0.7070248679836498 -9.979196145641633e-08 -0.09995403770624278 -2.7575 0.7070262078689511 0.7070248932773799 -1.0020402408696116e-07 -0.09995405166552446 -2.7576000000000005 0.7070262319226512 0.7070249185678763 -1.0060278615806745e-07 -0.09995406562056752 -2.7577000000000003 0.7070262559647422 0.7070249438549974 -1.0098815970797925e-07 -0.09995407957137324 -2.7578 0.707026279995371 0.7070249691386005 -1.0136005988876928e-07 -0.09995409351794288 -2.7579000000000002 0.7070263040146857 0.7070249944185423 -1.0171840498889029e-07 -0.09995410746027783 -2.758 0.7070263280228347 0.7070250196946779 -1.0206311644792021e-07 -0.09995412139837917 -2.7581 0.7070263520199682 0.707025044966863 -1.0239411887477678e-07 -0.09995413533224838 -2.7582000000000004 0.7070263760062365 0.7070250702349514 -1.027113400598606e-07 -0.09995414926188667 -2.7583 0.7070263999817907 0.7070250954987962 -1.0301471099847387e-07 -0.09995416318729532 -2.7584 0.707026423946783 0.7070251207582506 -1.0330416590469821e-07 -0.09995417710847568 -2.7585 0.7070264479013653 0.7070251460131662 -1.0357964221920091e-07 -0.09995419102542896 -2.7586000000000004 0.7070264718456913 0.7070251712633948 -1.0384108062744951e-07 -0.09995420493815649 -2.7587 0.7070264957799143 0.7070251965087868 -1.0408842507532434e-07 -0.0999542188466595 -2.7588000000000004 0.7070265197041892 0.7070252217491926 -1.0432162277432266e-07 -0.09995423275093934 -2.7589 0.7070265436186702 0.7070252469844613 -1.0454062421543647e-07 -0.09995424665099717 -2.759 0.7070265675235131 0.7070252722144428 -1.0474538317869347e-07 -0.09995426054683437 -2.7591000000000006 0.7070265914188736 0.7070252974389855 -1.049358567487696e-07 -0.09995427443845219 -2.7592000000000003 0.7070266153049078 0.7070253226579377 -1.0511200531498899e-07 -0.09995428832585194 -2.7593 0.7070266391817727 0.7070253478711479 -1.05273792580865e-07 -0.09995430220903494 -2.7594000000000003 0.7070266630496246 0.7070253730784631 -1.0542118557884533e-07 -0.09995431608800237 -2.7595 0.7070266869086212 0.7070253982797308 -1.0555415467204676e-07 -0.09995432996275559 -2.7596000000000003 0.7070267107589198 0.7070254234747978 -1.0567267356206139e-07 -0.0999543438332958 -2.7597000000000005 0.7070267346006784 0.7070254486635109 -1.057767192880893e-07 -0.09995435769962435 -2.7598000000000003 0.7070267584340546 0.7070254738457169 -1.0586627223734685e-07 -0.09995437156174247 -2.7599 0.707026782259207 0.7070254990212619 -1.0594131614506674e-07 -0.09995438541965147 -2.76 0.7070268060762936 0.7070255241899923 -1.0600183810230424e-07 -0.09995439927335262 -2.7601000000000004 0.7070268298854727 0.7070255493517541 -1.0604782855246769e-07 -0.09995441312284715 -2.7602 0.707026853686903 0.7070255745063936 -1.0607928128958388e-07 -0.09995442696813645 -2.7603 0.7070268774807427 0.7070255996537566 -1.0609619347477783e-07 -0.09995444080922165 -2.7604 0.7070269012671506 0.7070256247936892 -1.0609856561285408e-07 -0.09995445464610415 -2.7605 0.7070269250462848 0.7070256499260376 -1.0608640156964388e-07 -0.09995446847878518 -2.7606 0.7070269488183037 0.7070256750506482 -1.0605970856593372e-07 -0.09995448230726602 -2.7607000000000004 0.7070269725833653 0.7070257001673668 -1.060184971627201e-07 -0.09995449613154787 -2.7608 0.7070269963416278 0.7070257252760405 -1.0596278127422004e-07 -0.09995450995163212 -2.7609 0.7070270200932492 0.7070257503765155 -1.0589257815746267e-07 -0.09995452376752 -2.761 0.7070270438383871 0.7070257754686391 -1.0580790840448301e-07 -0.0999545375792128 -2.7611000000000003 0.7070270675771987 0.707025800552258 -1.0570879593798516e-07 -0.09995455138671178 -2.7612 0.7070270913098408 0.7070258256272197 -1.0559526800440339e-07 -0.09995456519001815 -2.7613000000000003 0.7070271150364705 0.7070258506933723 -1.0546735517216743e-07 -0.09995457898913328 -2.7614 0.707027138757244 0.7070258757505636 -1.0532509131782469e-07 -0.09995459278405835 -2.7615 0.7070271624723176 0.7070259007986424 -1.0516851361649926e-07 -0.09995460657479471 -2.7616000000000005 0.707027186181846 0.7070259258374574 -1.0499766253495302e-07 -0.09995462036134356 -2.7617000000000003 0.7070272098859851 0.7070259508668584 -1.0481258182204467e-07 -0.09995463414370626 -2.7618 0.7070272335848888 0.707025975886695 -1.0461331849398459e-07 -0.099954647921884 -2.7619000000000002 0.7070272572787117 0.7070260008968181 -1.0439992282219174e-07 -0.0999546616958781 -2.762 0.7070272809676068 0.7070260258970787 -1.0417244833069161e-07 -0.09995467546568985 -2.7621 0.7070273046517268 0.7070260508873285 -1.0393095177356482e-07 -0.09995468923132048 -2.7622000000000004 0.707027328331224 0.70702607586742 -1.03675493122804e-07 -0.09995470299277123 -2.7623 0.7070273520062496 0.7070261008372059 -1.0340613554662981e-07 -0.09995471675004342 -2.7624 0.7070273756769547 0.70702612579654 -1.0312294540775618e-07 -0.0999547305031383 -2.7625 0.7070273993434887 0.7070261507452771 -1.0282599223910421e-07 -0.0999547442520571 -2.7626000000000004 0.7070274230060013 0.7070261756832725 -1.025153487264549e-07 -0.09995475799680117 -2.7627 0.7070274466646406 0.7070262006103821 -1.0219109069370402e-07 -0.09995477173737172 -2.7628000000000004 0.707027470319554 0.7070262255264632 -1.0185329707684126e-07 -0.09995478547377001 -2.7629 0.7070274939708886 0.7070262504313733 -1.015020499178787e-07 -0.09995479920599736 -2.763 0.7070275176187897 0.7070262753249713 -1.0113743433622785e-07 -0.09995481293405498 -2.7631000000000006 0.7070275412634022 0.707026300207117 -1.00759538507883e-07 -0.09995482665794415 -2.7632000000000003 0.7070275649048698 0.7070263250776707 -1.0036845364807395e-07 -0.09995484037766615 -2.7633 0.7070275885433353 0.707026349936495 -9.996427398177576e-08 -0.09995485409322225 -2.7634000000000003 0.70702761217894 0.7070263747834518 -9.954709673503509e-08 -0.09995486780461363 -2.7635 0.707027635811825 0.7070263996184055 -9.911702210114309e-08 -0.0999548815118417 -2.7636000000000003 0.7070276594421299 0.7070264244412208 -9.867415321114514e-08 -0.09995489521490758 -2.7637000000000005 0.7070276830699925 0.7070264492517637 -9.821859612083039e-08 -0.09995490891381265 -2.7638000000000003 0.7070277066955506 0.7070264740499022 -9.775045978384356e-08 -0.09995492260855815 -2.7639 0.7070277303189396 0.7070264988355038 -9.726985602306198e-08 -0.09995493629914524 -2.764 0.7070277539402946 0.7070265236084391 -9.67768994976359e-08 -0.0999549499855753 -2.7641000000000004 0.7070277775597487 0.7070265483685785 -9.627170768737592e-08 -0.09995496366784952 -2.7642 0.7070278011774346 0.7070265731157946 -9.575440086066062e-08 -0.09995497734596924 -2.7643 0.7070278247934826 0.7070265978499609 -9.522510203800738e-08 -0.09995499101993563 -2.7644 0.7070278484080226 0.7070266225709525 -9.46839369738578e-08 -0.09995500468975 -2.7645 0.7070278720211822 0.7070266472786455 -9.413103412101581e-08 -0.09995501835541358 -2.7646 0.7070278956330889 0.7070266719729181 -9.35665246020248e-08 -0.0999550320169277 -2.7647000000000004 0.7070279192438672 0.7070266966536494 -9.299054217794256e-08 -0.09995504567429359 -2.7648 0.7070279428536411 0.7070267213207198 -9.240322321538152e-08 -0.09995505932751246 -2.7649 0.7070279664625331 0.7070267459740116 -9.18047066526817e-08 -0.09995507297658562 -2.765 0.7070279900706636 0.7070267706134084 -9.119513397215506e-08 -0.09995508662151427 -2.7651000000000003 0.7070280136781519 0.7070267952387956 -9.057464916625846e-08 -0.09995510026229974 -2.7652 0.7070280372851159 0.7070268198500602 -8.994339869422552e-08 -0.09995511389894324 -2.7653000000000003 0.707028060891671 0.7070268444470902 -8.930153146385206e-08 -0.099955127531446 -2.7654 0.7070280844979322 0.7070268690297759 -8.864919877945437e-08 -0.09995514115980934 -2.7655 0.7070281081040121 0.707026893598009 -8.79865543158484e-08 -0.09995515478403451 -2.7656000000000005 0.7070281317100215 0.7070269181516831 -8.731375408278785e-08 -0.09995516840412277 -2.7657000000000003 0.7070281553160701 0.7070269426906928 -8.66309563833309e-08 -0.09995518202007532 -2.7658 0.7070281789222652 0.7070269672149353 -8.593832178001304e-08 -0.09995519563189348 -2.7659000000000002 0.7070282025287129 0.7070269917243089 -8.52360130558158e-08 -0.09995520923957843 -2.766 0.7070282261355172 0.7070270162187144 -8.452419517600285e-08 -0.0999552228431315 -2.7661000000000002 0.7070282497427802 0.7070270406980534 -8.38030352516908e-08 -0.0999552364425539 -2.7662000000000004 0.7070282733506026 0.7070270651622305 -8.307270249561377e-08 -0.09995525003784693 -2.7663 0.7070282969590829 0.707027089611151 -8.233336818569414e-08 -0.09995526362901175 -2.7664 0.707028320568318 0.7070271140447227 -8.158520562427662e-08 -0.09995527721604974 -2.7665 0.7070283441784027 0.7070271384628555 -8.08283901043011e-08 -0.09995529079896211 -2.7666000000000004 0.7070283677894297 0.7070271628654603 -8.006309885639357e-08 -0.09995530437775002 -2.7667 0.7070283914014903 0.707027187252451 -7.928951101330434e-08 -0.09995531795241483 -2.7668000000000004 0.7070284150146737 0.7070272116237424 -7.850780756480519e-08 -0.09995533152295773 -2.7669 0.7070284386290671 0.7070272359792522 -7.771817132386227e-08 -0.09995534508938002 -2.767 0.707028462244755 0.7070272603188996 -7.692078687112497e-08 -0.09995535865168288 -2.7671000000000006 0.7070284858618211 0.7070272846426059 -7.61158405271703e-08 -0.09995537220986765 -2.7672000000000003 0.7070285094803463 0.7070273089502943 -7.530352029612442e-08 -0.09995538576393548 -2.7673 0.7070285331004096 0.7070273332418904 -7.44840158274987e-08 -0.09995539931388771 -2.7674000000000003 0.7070285567220883 0.7070273575173216 -7.365751836675011e-08 -0.09995541285972556 -2.7675 0.7070285803454569 0.7070273817765169 -7.282422072102043e-08 -0.09995542640145022 -2.7676000000000003 0.7070286039705886 0.7070274060194086 -7.198431720362511e-08 -0.09995543993906306 -2.7677000000000005 0.707028627597554 0.7070274302459296 -7.113800359372091e-08 -0.09995545347256518 -2.7678000000000003 0.7070286512264219 0.7070274544560167 -7.02854770920705e-08 -0.09995546700195795 -2.7679 0.7070286748572583 0.7070274786496069 -6.942693626943441e-08 -0.09995548052724257 -2.768 0.7070286984901277 0.7070275028266406 -6.856258102797344e-08 -0.09995549404842026 -2.7681000000000004 0.7070287221250927 0.7070275269870603 -6.769261254747222e-08 -0.09995550756549235 -2.7682 0.7070287457622129 0.7070275511308102 -6.68172332428385e-08 -0.09995552107845998 -2.7683 0.707028769401546 0.707027575257837 -6.59366467133625e-08 -0.09995553458732451 -2.7684 0.707028793043148 0.7070275993680892 -6.505105770195085e-08 -0.09995554809208708 -2.7685 0.707028816687072 0.7070276234615184 -6.416067204395234e-08 -0.09995556159274904 -2.7686 0.7070288403333691 0.7070276475380772 -6.326569661554982e-08 -0.09995557508931152 -2.7687000000000004 0.7070288639820884 0.7070276715977216 -6.236633929039212e-08 -0.09995558858177583 -2.7688 0.7070288876332763 0.7070276956404091 -6.14628088897208e-08 -0.0999556020701432 -2.7689 0.7070289112869774 0.7070277196660997 -6.055531513553258e-08 -0.09995561555441485 -2.769 0.7070289349432339 0.7070277436747554 -5.964406859983867e-08 -0.09995562903459204 -2.7691000000000003 0.7070289586020855 0.707027767666341 -5.872928065674306e-08 -0.09995564251067601 -2.7692 0.7070289822635702 0.7070277916408234 -5.7811163431918666e-08 -0.09995565598266805 -2.7693000000000003 0.7070290059277229 0.7070278155981716 -5.688992975533616e-08 -0.09995566945056937 -2.7694 0.7070290295945769 0.707027839538357 -5.5965793112908516e-08 -0.09995568291438123 -2.7695 0.7070290532641628 0.7070278634613529 -5.503896759509984e-08 -0.09995569637410481 -2.7696000000000005 0.7070290769365087 0.7070278873671356 -5.4109667846184706e-08 -0.09995570982974136 -2.7697000000000003 0.7070291006116411 0.7070279112556833 -5.317810901849483e-08 -0.09995572328129217 -2.7698 0.7070291242895836 0.7070279351269766 -5.224450671885948e-08 -0.09995573672875845 -2.7699000000000003 0.7070291479703579 0.7070279589809987 -5.1309076959599534e-08 -0.09995575017214145 -2.77 0.7070291716539826 0.7070279828177344 -5.037203610897944e-08 -0.09995576361144236 -2.7701000000000002 0.7070291953404751 0.7070280066371717 -4.943360084274338e-08 -0.09995577704666253 -2.7702000000000004 0.7070292190298497 0.7070280304393002 -4.849398809218201e-08 -0.09995579047780312 -2.7703 0.7070292427221185 0.7070280542241125 -4.755341499501804e-08 -0.09995580390486541 -2.7704 0.7070292664172911 0.7070280779916027 -4.66120988438525e-08 -0.09995581732785058 -2.7705 0.7070292901153754 0.707028101741768 -4.567025703629138e-08 -0.0999558307467599 -2.7706000000000004 0.7070293138163761 0.7070281254746075 -4.4728107026427606e-08 -0.0999558441615946 -2.7707 0.7070293375202963 0.7070281491901227 -4.378586627231144e-08 -0.09995585757235592 -2.7708000000000004 0.707029361227136 0.7070281728883179 -4.2843752188963876e-08 -0.09995587097904508 -2.7709 0.7070293849368938 0.7070281965691989 -4.1901982093759944e-08 -0.09995588438166333 -2.771 0.7070294086495655 0.7070282202327748 -4.0960773160390786e-08 -0.09995589778021197 -2.7711000000000006 0.7070294323651444 0.7070282438790563 -4.0020342366876155e-08 -0.09995591117469216 -2.7712000000000003 0.7070294560836216 0.7070282675080564 -3.908090644529809e-08 -0.09995592456510516 -2.7713 0.7070294798049859 0.7070282911197909 -3.814268183330999e-08 -0.09995593795145219 -2.7714000000000003 0.7070295035292237 0.7070283147142777 -3.720588462340947e-08 -0.09995595133373447 -2.7715 0.7070295272563194 0.7070283382915368 -3.6270730511493016e-08 -0.09995596471195327 -2.7716000000000003 0.7070295509862548 0.7070283618515906 -3.533743475148208e-08 -0.09995597808610976 -2.7717 0.7070295747190094 0.7070283853944641 -3.4406212101600886e-08 -0.09995599145620526 -2.7718000000000003 0.7070295984545603 0.7070284089201846 -3.347727677883994e-08 -0.09995600482224092 -2.7719 0.7070296221928827 0.7070284324287812 -3.255084240409538e-08 -0.09995601818421804 -2.772 0.7070296459339491 0.707028455920286 -3.1627121958909335e-08 -0.09995603154213786 -2.7721000000000005 0.7070296696777301 0.7070284793947326 -3.0706327732669264e-08 -0.09995604489600157 -2.7722 0.7070296934241934 0.7070285028521575 -2.9788671276637785e-08 -0.09995605824581039 -2.7723 0.7070297171733051 0.7070285262925986 -2.8874363352561494e-08 -0.09995607159156553 -2.7724 0.707029740925029 0.7070285497160974 -2.7963613887568156e-08 -0.09995608493326831 -2.7725 0.707029764679326 0.7070285731226964 -2.7056631921691318e-08 -0.09995609827091988 -2.7726 0.7070297884361557 0.7070285965124412 -2.6153625564719063e-08 -0.0999561116045215 -2.7727000000000004 0.7070298121954747 0.707028619885379 -2.5254801944585986e-08 -0.0999561249340744 -2.7728 0.7070298359572378 0.7070286432415596 -2.4360367161836705e-08 -0.09995613825957982 -2.7729 0.7070298597213973 0.707028666581035 -2.3470526242571482e-08 -0.099956151581039 -2.773 0.7070298834879035 0.7070286899038589 -2.2585483090090813e-08 -0.09995616489845309 -2.7731000000000003 0.7070299072567048 0.707028713210088 -2.1705440438057888e-08 -0.0999561782118234 -2.7732 0.7070299310277467 0.70702873649978 -2.0830599805395783e-08 -0.09995619152115111 -2.7733000000000003 0.7070299548009734 0.7070287597729961 -1.9961161452052012e-08 -0.09995620482643748 -2.7734 0.7070299785763264 0.7070287830297985 -1.9097324328691545e-08 -0.09995621812768371 -2.7735 0.7070300023537452 0.7070288062702523 -1.8239286033328722e-08 -0.09995623142489102 -2.7736000000000005 0.7070300261331677 0.7070288294944242 -1.7387242766658123e-08 -0.09995624471806068 -2.7737000000000003 0.7070300499145283 0.7070288527023834 -1.654138928738544e-08 -0.09995625800719382 -2.7738 0.7070300736977613 0.7070288758942008 -1.5701918864956255e-08 -0.09995627129229184 -2.7739000000000003 0.7070300974827974 0.7070288990699497 -1.4869023241825818e-08 -0.09995628457335584 -2.774 0.7070301212695658 0.7070289222297051 -1.4042892578815247e-08 -0.09995629785038707 -2.7741000000000002 0.7070301450579937 0.7070289453735443 -1.3223715423886506e-08 -0.09995631112338674 -2.7742000000000004 0.7070301688480061 0.7070289685015462 -1.2411678661835429e-08 -0.09995632439235605 -2.7743 0.7070301926395262 0.7070289916137922 -1.1606967473525714e-08 -0.09995633765729624 -2.7744 0.7070302164324749 0.7070290147103653 -1.080976529252084e-08 -0.09995635091820852 -2.7745 0.7070302402267723 0.7070290377913508 -1.0020253764751741e-08 -0.0999563641750942 -2.7746000000000004 0.7070302640223349 0.7070290608568356 -9.238612706449767e-09 -0.09995637742795441 -2.7747 0.7070302878190786 0.7070290839069087 -8.465020066850126e-09 -0.09995639067679046 -2.7748000000000004 0.7070303116169168 0.7070291069416608 -7.699651882221714e-09 -0.09995640392160347 -2.7749 0.7070303354157612 0.7070291299611848 -6.94268223466743e-09 -0.09995641716239478 -2.775 0.7070303592155214 0.7070291529655746 -6.194283217429708e-09 -0.09995643039916546 -2.7751000000000006 0.7070303830161053 0.707029175954927 -5.454624897593963e-09 -0.09995644363191682 -2.7752000000000003 0.7070304068174194 0.7070291989293401 -4.723875268383693e-09 -0.09995645686065008 -2.7753 0.7070304306193678 0.7070292218889138 -4.0022002222722675e-09 -0.0999564700853664 -2.7754000000000003 0.7070304544218532 0.70702924483375 -3.289763508482202e-09 -0.0999564833060671 -2.7755 0.7070304782247768 0.7070292677639514 -2.586726687882346e-09 -0.09995649652275332 -2.7756000000000003 0.7070305020280376 0.7070292906796238 -1.8932491113038408e-09 -0.0999565097354263 -2.7757 0.707030525831533 0.7070293135808741 -1.2094878709678625e-09 -0.0999565229440873 -2.7758000000000003 0.707030549635159 0.70702933646781 -5.355977709953219e-10 -0.09995653614873745 -2.7759 0.7070305734388096 0.7070293593405421 1.2826870988968953e-10 -0.09995654934937803 -2.776 0.7070305972423778 0.707029382199182 7.819614487175608e-10 -0.09995656254601026 -2.7761000000000005 0.7070306210457544 0.707029405043843 1.425332719039163e-09 -0.09995657573863534 -2.7762000000000002 0.7070306448488288 0.70702942787464 2.0582372160793394e-09 -0.09995658892725445 -2.7763 0.7070306686514891 0.707029450691689 2.6805320949008227e-09 -0.09995660211186887 -2.7764 0.7070306924536214 0.7070294734951083 3.2920770059660653e-09 -0.09995661529247973 -2.7765 0.7070307162551108 0.7070294962850169 3.892734118556007e-09 -0.0999566284690883 -2.7766 0.7070307400558413 0.707029519061536 4.4823681554645445e-09 -0.09995664164169585 -2.7767000000000004 0.7070307638556944 0.7070295418247876 5.060846425090915e-09 -0.09995665481030352 -2.7768 0.7070307876545513 0.7070295645748953 5.6280388526647185e-09 -0.0999566679749126 -2.7769 0.707030811452291 0.707029587311984 6.18381800019524e-09 -0.09995668113552422 -2.777 0.7070308352487913 0.7070296100361801 6.728059105502726e-09 -0.09995669429213963 -2.7771000000000003 0.7070308590439294 0.7070296327476111 7.260640110841321e-09 -0.09995670744476007 -2.7772 0.7070308828375802 0.7070296554464058 7.781441674174772e-09 -0.09995672059338664 -2.7773000000000003 0.707030906629618 0.7070296781326946 8.290347216881322e-09 -0.09995673373802066 -2.7774 0.7070309304199158 0.7070297008066084 8.787242935896777e-09 -0.09995674687866328 -2.7775 0.7070309542083455 0.7070297234682803 9.272017836674251e-09 -0.09995676001531578 -2.7776000000000005 0.7070309779947777 0.7070297461178439 9.744563750531399e-09 -0.09995677314797935 -2.7777000000000003 0.7070310017790817 0.7070297687554337 1.0204775366742802e-08 -0.09995678627665522 -2.7778 0.7070310255611258 0.7070297913811858 1.0652550250754567e-08 -0.09995679940134454 -2.7779000000000003 0.7070310493407774 0.7070298139952369 1.1087788865868364e-08 -0.09995681252204848 -2.778 0.707031073117903 0.7070298365977252 1.1510394603599094e-08 -0.09995682563876838 -2.7781000000000002 0.7070310968923674 0.7070298591887898 1.1920273792348501e-08 -0.09995683875150535 -2.7782000000000004 0.7070311206640352 0.7070298817685708 1.2317335734701729e-08 -0.09995685186026065 -2.7783 0.7070311444327696 0.7070299043372088 1.2701492706559958e-08 -0.09995686496503546 -2.7784 0.7070311681984334 0.7070299268948459 1.3072659994436964e-08 -0.09995687806583103 -2.7785 0.7070311919608878 0.7070299494416246 1.3430755906734815e-08 -0.09995689116264854 -2.7786000000000004 0.7070312157199937 0.7070299719776884 1.3775701793693196e-08 -0.09995690425548916 -2.7787 0.7070312394756112 0.7070299945031817 1.4107422060399832e-08 -0.09995691734435419 -2.7788000000000004 0.707031263227599 0.7070300170182495 1.4425844184137726e-08 -0.09995693042924471 -2.7789 0.7070312869758162 0.7070300395230378 1.4730898738671283e-08 -0.09995694351016203 -2.779 0.7070313107201198 0.707030062017693 1.5022519398583123e-08 -0.0999569565871073 -2.7791000000000006 0.7070313344603674 0.7070300845023625 1.5300642960958122e-08 -0.09995696966008176 -2.7792000000000003 0.7070313581964152 0.7070301069771938 1.556520935405703e-08 -0.09995698272908657 -2.7793 0.7070313819281187 0.7070301294423357 1.581616164599009e-08 -0.09995699579412295 -2.7794 0.7070314056553337 0.7070301518979374 1.6053446074207334e-08 -0.09995700885519218 -2.7795 0.7070314293779144 0.7070301743441483 1.627701203855969e-08 -0.09995702191229543 -2.7796000000000003 0.7070314530957151 0.7070301967811186 1.648681212298303e-08 -0.09995703496543384 -2.7797 0.7070314768085897 0.7070302192089986 1.668280209983497e-08 -0.09995704801460868 -2.7798000000000003 0.7070315005163912 0.7070302416279393 1.6864940944640028e-08 -0.0999570610598211 -2.7799 0.7070315242189726 0.7070302640380921 1.703319083782434e-08 -0.09995707410107234 -2.78 0.7070315479161863 0.707030286439609 1.718751716991984e-08 -0.09995708713836356 -2.7801000000000005 0.7070315716078848 0.707030308832642 1.732788856585038e-08 -0.09995710017169605 -2.7802000000000002 0.7070315952939192 0.7070303312173432 1.745427687018658e-08 -0.09995711320107088 -2.7803 0.7070316189741421 0.7070303535938655 1.7566657167095157e-08 -0.09995712622648939 -2.7804 0.7070316426484043 0.7070303759623617 1.766500777773683e-08 -0.0999571392479527 -2.7805 0.7070316663165569 0.7070303983229849 1.7749310268072582e-08 -0.09995715226546201 -2.7806 0.7070316899784512 0.7070304206758884 1.7819549450598382e-08 -0.09995716527901854 -2.7807000000000004 0.7070317136339379 0.7070304430212254 1.787571338868199e-08 -0.0999571782886235 -2.7808 0.7070317372828682 0.7070304653591495 1.791779339396088e-08 -0.09995719129427807 -2.7809 0.7070317609250923 0.7070304876898137 1.7945784030679035e-08 -0.09995720429598345 -2.781 0.7070317845604615 0.7070305100133718 1.7959683117421688e-08 -0.09995721729374084 -2.7811000000000003 0.7070318081888263 0.7070305323299777 1.7959491721911136e-08 -0.09995723028755146 -2.7812 0.7070318318100373 0.7070305546397839 1.7945214162741474e-08 -0.09995724327741644 -2.7813000000000003 0.7070318554239456 0.7070305769429448 1.7916858005909142e-08 -0.09995725626333707 -2.7814 0.7070318790304024 0.7070305992396128 1.7874434067415013e-08 -0.0999572692453145 -2.7815 0.7070319026292589 0.7070306215299416 1.7817956401121327e-08 -0.09995728222334999 -2.7816000000000005 0.7070319262203659 0.7070306438140834 1.774744230222114e-08 -0.09995729519744462 -2.7817000000000003 0.7070319498035754 0.7070306660921912 1.7662912297697342e-08 -0.09995730816759964 -2.7818 0.7070319733787392 0.7070306883644176 1.7564390141985853e-08 -0.09995732113381628 -2.7819000000000003 0.7070319969457095 0.7070307106309142 1.7451902809169362e-08 -0.09995733409609568 -2.782 0.7070320205043388 0.707030732891833 1.7325480489507883e-08 -0.09995734705443908 -2.7821000000000002 0.7070320440544797 0.7070307551473254 1.7185156580765137e-08 -0.0999573600088476 -2.7822000000000005 0.7070320675959857 0.7070307773975422 1.703096767086132e-08 -0.09995737295932254 -2.7823 0.7070320911287105 0.7070307996426344 1.686295354134254e-08 -0.09995738590586506 -2.7824 0.707032114652508 0.7070308218827515 1.668115715090096e-08 -0.0999573988484763 -2.7825 0.7070321381672329 0.7070308441180435 1.6485624619762274e-08 -0.0999574117871575 -2.7826000000000004 0.7070321616727404 0.7070308663486593 1.6276405232287794e-08 -0.09995742472190983 -2.7827 0.7070321851688863 0.7070308885747474 1.6053551410086242e-08 -0.09995743765273454 -2.7828000000000004 0.707032208655527 0.7070309107964559 1.5817118705942212e-08 -0.09995745057963276 -2.7829 0.7070322321325191 0.7070309330139315 1.55671657873363e-08 -0.09995746350260568 -2.783 0.7070322555997205 0.7070309552273214 1.5303754419965232e-08 -0.09995747642165453 -2.7831000000000006 0.7070322790569894 0.7070309774367709 1.50269494599356e-08 -0.0999574893367804 -2.7832000000000003 0.7070323025041851 0.7070309996424256 1.4736818836416643e-08 -0.09995750224798464 -2.7833 0.7070323259411675 0.7070310218444297 1.4433433528221462e-08 -0.09995751515526834 -2.7834 0.707032349367797 0.7070310440429268 1.4116867550796608e-08 -0.09995752805863273 -2.7835 0.7070323727839352 0.7070310662380597 1.3787197941476925e-08 -0.09995754095807902 -2.7836000000000003 0.7070323961894444 0.70703108842997 1.3444504735199425e-08 -0.09995755385360831 -2.7837 0.7070324195841877 0.707031110618799 1.3088870945421327e-08 -0.09995756674522185 -2.7838000000000003 0.7070324429680294 0.7070311328046863 1.2720382546772824e-08 -0.09995757963292079 -2.7839 0.7070324663408346 0.7070311549877715 1.2339128457709847e-08 -0.09995759251670638 -2.784 0.7070324897024693 0.7070311771681923 1.1945200511023768e-08 -0.09995760539657975 -2.7841000000000005 0.707032513052801 0.7070311993460862 1.1538693431289992e-08 -0.09995761827254215 -2.7842000000000002 0.7070325363916977 0.7070312215215887 1.1119704826194343e-08 -0.09995763114459474 -2.7843 0.7070325597190286 0.7070312436948349 1.0688335147501782e-08 -0.09995764401273866 -2.7844 0.7070325830346642 0.7070312658659589 1.0244687678913345e-08 -0.0999576568769752 -2.7845 0.7070326063384756 0.7070312880350931 9.788868493565417e-09 -0.09995766973730542 -2.7846 0.7070326296303361 0.7070313102023689 9.320986454029734e-09 -0.09995768259373058 -2.7847000000000004 0.7070326529101192 0.7070313323679166 8.841153165475846e-09 -0.09995769544625183 -2.7848 0.7070326761777004 0.7070313545318655 8.349482955721799e-09 -0.0999577082948704 -2.7849 0.7070326994329557 0.7070313766943431 7.846092852682729e-09 -0.09995772113958741 -2.785 0.7070327226757627 0.7070313988554762 7.331102552278479e-09 -0.09995773398040407 -2.7851000000000004 0.7070327459060008 0.7070314210153898 6.804634386341213e-09 -0.09995774681732163 -2.7852 0.7070327691235503 0.7070314431742081 6.26681329919665e-09 -0.0999577596503412 -2.7853000000000003 0.7070327923282931 0.7070314653320531 5.717766821643211e-09 -0.09995777247946407 -2.7854 0.707032815520112 0.707031487489046 5.157625028451296e-09 -0.09995778530469127 -2.7855 0.7070328386988913 0.7070315096453063 4.586520523618132e-09 -0.09995779812602403 -2.7856000000000005 0.7070328618645174 0.7070315318009524 4.004588390928154e-09 -0.09995781094346358 -2.7857000000000003 0.7070328850168777 0.707031553956101 3.4119661792078593e-09 -0.09995782375701104 -2.7858 0.7070329081558615 0.707031576110867 2.808793856355629e-09 -0.09995783656666767 -2.7859000000000003 0.7070329312813587 0.7070315982653641 2.1952137807187966e-09 -0.09995784937243456 -2.786 0.7070329543932616 0.7070316204197047 1.5713706716033449e-09 -0.0999578621743129 -2.7861000000000002 0.7070329774914643 0.7070316425739993 9.374115728447152e-10 -0.09995787497230399 -2.7862000000000005 0.7070330005758616 0.7070316647283563 2.9348581551125186e-10 -0.0999578877664089 -2.7863 0.7070330236463507 0.7070316868828836 -3.602550124534587e-10 -0.09995790055662884 -2.7864 0.7070330467028298 0.7070317090376863 -1.0236571069965894e-09 -0.09995791334296496 -2.7865 0.7070330697451996 0.7070317311928687 -1.6965644791810952e-09 -0.09995792612541848 -2.7866000000000004 0.7070330927733619 0.7070317533485326 -2.3788189985538e-09 -0.09995793890399057 -2.7867 0.70703311578722 0.7070317755047788 -3.070260421768334e-09 -0.09995795167868235 -2.7868000000000004 0.7070331387866797 0.707031797661706 -3.770726436820582e-09 -0.09995796444949509 -2.7869 0.7070331617716481 0.7070318198194112 -4.480052697743153e-09 -0.0999579772164299 -2.787 0.7070331847420341 0.7070318419779895 -5.198072867973469e-09 -0.099957989979488 -2.7871000000000006 0.7070332076977488 0.7070318641375346 -5.924618648976698e-09 -0.09995800273867059 -2.7872000000000003 0.7070332306387045 0.7070318862981378 -6.659519832287464e-09 -0.09995801549397879 -2.7873 0.7070332535648156 0.7070319084598886 -7.4026043298675015e-09 -0.09995802824541375 -2.7874 0.7070332764759985 0.7070319306228751 -8.153698219208472e-09 -0.0999580409929767 -2.7875 0.7070332993721715 0.7070319527871831 -8.912625782363237e-09 -0.0999580537366688 -2.7876000000000003 0.7070333222532548 0.7070319749528967 -9.679209548446588e-09 -0.09995806647649125 -2.7877 0.7070333451191704 0.707031997120098 -1.045327033266652e-08 -0.0999580792124452 -2.7878000000000003 0.7070333679698422 0.7070320192888672 -1.1234627279258641e-08 -0.09995809194453183 -2.7879 0.707033390805196 0.7070320414592821 -1.2023097904420577e-08 -0.09995810467275223 -2.788 0.7070334136251604 0.7070320636314193 -1.2818498138379014e-08 -0.09995811739710773 -2.7881000000000005 0.7070334364296648 0.7070320858053529 -1.3620642370926195e-08 -0.09995813011759941 -2.7882000000000002 0.7070334592186414 0.7070321079811552 -1.4429343488282786e-08 -0.09995814283422846 -2.7883 0.707033481992024 0.7070321301588962 -1.5244412921670142e-08 -0.09995815554699608 -2.7884 0.7070335047497487 0.707032152338644 -1.606566069371415e-08 -0.09995816825590337 -2.7885 0.7070335274917534 0.7070321745204646 -1.6892895454007073e-08 -0.09995818096095152 -2.7886 0.7070335502179788 0.7070321967044224 -1.7725924532450282e-08 -0.09995819366214177 -2.7887000000000004 0.7070335729283668 0.7070322188905789 -1.8564553977851866e-08 -0.09995820635947526 -2.7888 0.7070335956228615 0.7070322410789942 -1.940858860996833e-08 -0.09995821905295314 -2.7889 0.7070336183014094 0.7070322632697256 -2.0257832055066427e-08 -0.09995823174257656 -2.789 0.7070336409639597 0.707032285462829 -2.1112086805337438e-08 -0.09995824442834675 -2.7891000000000004 0.7070336636104624 0.7070323076583577 -2.197115424882115e-08 -0.09995825711026483 -2.7892 0.7070336862408708 0.7070323298563632 -2.2834834726218056e-08 -0.09995826978833205 -2.7893000000000003 0.7070337088551396 0.7070323520568942 -2.3702927574257432e-08 -0.09995828246254948 -2.7894 0.707033731453226 0.707032374259998 -2.457523117383592e-08 -0.09995829513291832 -2.7895 0.7070337540350895 0.7070323964657191 -2.5451542995554022e-08 -0.0999583077994397 -2.7896000000000005 0.7070337766006916 0.7070324186741003 -2.633165964438522e-08 -0.09995832046211486 -2.7897000000000003 0.707033799149996 0.7070324408851821 -2.7215376910416644e-08 -0.09995833312094496 -2.7898 0.7070338216829686 0.7070324630990024 -2.810248981568661e-08 -0.09995834577593109 -2.7899000000000003 0.7070338441995776 0.7070324853155973 -2.8992792660588462e-08 -0.09995835842707451 -2.79 0.7070338666997933 0.7070325075350007 -2.988607907135864e-08 -0.09995837107437634 -2.7901000000000002 0.7070338891835883 0.7070325297572442 -3.07821420501668e-08 -0.09995838371783777 -2.7902000000000005 0.7070339116509374 0.7070325519823568 -3.168077401848393e-08 -0.09995839635745996 -2.7903000000000002 0.7070339341018179 0.7070325742103658 -3.258176687064192e-08 -0.09995840899324404 -2.7904 0.7070339565362092 0.7070325964412958 -3.3484912016984794e-08 -0.09995842162519124 -2.7905 0.707033978954092 0.7070326186751694 -3.4390000437645174e-08 -0.09995843425330261 -2.7906000000000004 0.7070340013554508 0.7070326409120071 -3.529682272656286e-08 -0.09995844687757943 -2.7907 0.7070340237402715 0.7070326631518269 -3.6205169139948666e-08 -0.09995845949802279 -2.7908000000000004 0.707034046108542 0.7070326853946445 -3.711482964745879e-08 -0.09995847211463385 -2.7909 0.7070340684602536 0.7070327076404738 -3.8025593978490216e-08 -0.09995848472741388 -2.791 0.7070340907953989 0.707032729889326 -3.893725167162035e-08 -0.09995849733636399 -2.7911000000000006 0.7070341131139727 0.7070327521412099 -3.984959212372137e-08 -0.09995850994148531 -2.7912000000000003 0.7070341354159725 0.7070327743961322 -4.076240463723145e-08 -0.09995852254277901 -2.7913 0.7070341577013977 0.7070327966540979 -4.1675478470732785e-08 -0.09995853514024626 -2.7914 0.7070341799702502 0.707032818915109 -4.258860288470492e-08 -0.09995854773388824 -2.7915 0.7070342022225344 0.7070328411791653 -4.35015671930989e-08 -0.09995856032370604 -2.7916000000000003 0.7070342244582564 0.7070328634462646 -4.441416081149617e-08 -0.0999585729097009 -2.7917 0.707034246677425 0.7070328857164025 -4.532617330307875e-08 -0.09995858549187392 -2.7918000000000003 0.7070342688800512 0.707032907989572 -4.623739443046764e-08 -0.0999585980702263 -2.7919 0.7070342910661481 0.7070329302657644 -4.714761420122546e-08 -0.09995861064475926 -2.792 0.7070343132357312 0.7070329525449679 -4.8056622917831346e-08 -0.09995862321547387 -2.7921000000000005 0.707034335388818 0.7070329748271691 -4.8964211227784694e-08 -0.0999586357823713 -2.7922000000000002 0.7070343575254283 0.7070329971123523 -4.987017016813873e-08 -0.09995864834545272 -2.7923 0.7070343796455845 0.7070330194004995 -5.077429121569908e-08 -0.09995866090471926 -2.7924 0.7070344017493106 0.7070330416915902 -5.1676366333427634e-08 -0.09995867346017212 -2.7925 0.7070344238366337 0.7070330639856018 -5.257618802107476e-08 -0.09995868601181243 -2.7926 0.7070344459075824 0.70703308628251 -5.347354935995689e-08 -0.09995869855964139 -2.7927000000000004 0.7070344679621877 0.7070331085822876 -5.4368244063046633e-08 -0.0999587111036601 -2.7928 0.7070344900004829 0.7070331308849052 -5.526006651964191e-08 -0.0999587236438697 -2.7929 0.7070345120225037 0.707033153190332 -5.614881184415506e-08 -0.09995873618027148 -2.793 0.7070345340282871 0.7070331754985342 -5.703427592490193e-08 -0.09995874871286649 -2.7931000000000004 0.7070345560178734 0.7070331978094762 -5.7916255467903646e-08 -0.0999587612416559 -2.7932 0.7070345779913045 0.7070332201231198 -5.8794548046326237e-08 -0.09995877376664089 -2.7933000000000003 0.7070345999486246 0.7070332424394249 -5.966895214254767e-08 -0.09995878628782255 -2.7934 0.7070346218898799 0.7070332647583495 -6.05392671978143e-08 -0.09995879880520207 -2.7935 0.7070346438151187 0.707033287079849 -6.140529366059633e-08 -0.0999588113187806 -2.7936000000000005 0.707034665724392 0.7070333094038773 -6.226683302648639e-08 -0.09995882382855933 -2.7937000000000003 0.7070346876177522 0.7070333317303854 -6.312368788612133e-08 -0.09995883633453939 -2.7938 0.7070347094952543 0.7070333540593228 -6.397566197158602e-08 -0.09995884883672194 -2.7939000000000003 0.7070347313569549 0.7070333763906368 -6.482256020455199e-08 -0.09995886133510813 -2.794 0.7070347532029131 0.7070333987242721 -6.56641887292371e-08 -0.09995887382969908 -2.7941000000000003 0.7070347750331902 0.7070334210601721 -6.650035497095252e-08 -0.09995888632049602 -2.7942000000000005 0.7070347968478489 0.7070334433982775 -6.73308676703635e-08 -0.09995889880749996 -2.7943000000000002 0.7070348186469544 0.7070334657385273 -6.815553693162793e-08 -0.09995891129071219 -2.7944 0.707034840430574 0.7070334880808586 -6.897417426576444e-08 -0.09995892377013377 -2.7945 0.7070348621987768 0.7070335104252061 -6.978659262968367e-08 -0.0999589362457659 -2.7946000000000004 0.7070348839516339 0.7070335327715029 -7.05926064738932e-08 -0.09995894871760974 -2.7947 0.7070349056892182 0.7070335551196798 -7.139203178239614e-08 -0.09995896118566638 -2.7948000000000004 0.7070349274116056 0.707033577469666 -7.218468611389084e-08 -0.09995897364993707 -2.7949 0.7070349491188723 0.7070335998213885 -7.297038864687369e-08 -0.09995898611042292 -2.795 0.7070349708110977 0.7070336221747722 -7.374896021823674e-08 -0.09995899856712501 -2.7951000000000006 0.7070349924883621 0.7070336445297405 -7.452022336403366e-08 -0.09995901102004455 -2.7952000000000004 0.7070350141507485 0.7070336668862146 -7.528400235894475e-08 -0.09995902346918263 -2.7953 0.7070350357983418 0.7070336892441142 -7.604012325964499e-08 -0.09995903591454053 -2.7954 0.7070350574312281 0.7070337116033567 -7.678841393993219e-08 -0.09995904835611923 -2.7955 0.7070350790494955 0.7070337339638579 -7.752870413452878e-08 -0.09995906079391995 -2.7956000000000003 0.7070351006532345 0.7070337563255322 -7.826082547898044e-08 -0.09995907322794391 -2.7957 0.7070351222425366 0.7070337786882911 -7.898461153611064e-08 -0.09995908565819211 -2.7958000000000003 0.7070351438174958 0.7070338010520456 -7.969989784719494e-08 -0.09995909808466583 -2.7959 0.7070351653782072 0.7070338234167043 -8.040652196492082e-08 -0.09995911050736617 -2.796 0.7070351869247676 0.7070338457821741 -8.11043234915515e-08 -0.09995912292629423 -2.7961000000000005 0.7070352084572762 0.7070338681483603 -8.179314410754895e-08 -0.09995913534145122 -2.7962000000000002 0.7070352299758333 0.7070338905151665 -8.247282761754404e-08 -0.09995914775283826 -2.7963 0.7070352514805409 0.7070339128824947 -8.314321998156154e-08 -0.09995916016045649 -2.7964 0.707035272971503 0.7070339352502453 -8.380416934971463e-08 -0.09995917256430706 -2.7965 0.7070352944488244 0.7070339576183167 -8.445552609429724e-08 -0.09995918496439107 -2.7966 0.7070353159126124 0.7070339799866063 -8.509714285055009e-08 -0.09995919736070973 -2.7967000000000004 0.7070353373629752 0.7070340023550097 -8.57288745452836e-08 -0.09995920975326411 -2.7968 0.7070353588000231 0.707034024723421 -8.63505784246335e-08 -0.09995922214205544 -2.7969 0.7070353802238675 0.7070340470917327 -8.696211409395943e-08 -0.09995923452708483 -2.797 0.7070354016346214 0.7070340694598357 -8.756334354906997e-08 -0.09995924690835344 -2.7971000000000004 0.7070354230323992 0.7070340918276199 -8.815413120571297e-08 -0.09995925928586238 -2.7972 0.7070354444173166 0.7070341141949734 -8.873434392906582e-08 -0.09995927165961281 -2.7973000000000003 0.7070354657894908 0.7070341365617832 -8.930385106409311e-08 -0.09995928402960585 -2.7974 0.7070354871490404 0.7070341589279341 -8.986252446503695e-08 -0.09995929639584261 -2.7975 0.7070355084960853 0.7070341812933106 -9.041023852490726e-08 -0.09995930875832426 -2.7976000000000005 0.7070355298307471 0.7070342036577955 -9.094687020236997e-08 -0.09995932111705196 -2.7977000000000003 0.7070355511531482 0.7070342260212699 -9.147229905470677e-08 -0.09995933347202679 -2.7978 0.7070355724634125 0.7070342483836145 -9.19864072525603e-08 -0.09995934582324999 -2.7979000000000003 0.707035593761665 0.707034270744708 -9.248907961723063e-08 -0.09995935817072266 -2.798 0.707035615048032 0.7070342931044284 -9.29802036484309e-08 -0.09995937051444592 -2.7981000000000003 0.7070356363226409 0.707034315462652 -9.345966954076718e-08 -0.0999593828544209 -2.7982000000000005 0.7070356575856199 0.7070343378192544 -9.392737020802455e-08 -0.09995939519064873 -2.7983000000000002 0.7070356788370993 0.70703436017411 -9.438320131786165e-08 -0.0999594075231306 -2.7984 0.7070357000772096 0.7070343825270918 -9.482706130568841e-08 -0.09995941985186758 -2.7985 0.7070357213060825 0.7070344048780721 -9.525885139895218e-08 -0.09995943217686083 -2.7986000000000004 0.707035742523851 0.7070344272269221 -9.567847563708709e-08 -0.0999594444981115 -2.7987 0.7070357637306488 0.7070344495735119 -9.608584089926958e-08 -0.09995945681562068 -2.7988000000000004 0.7070357849266111 0.7070344719177108 -9.648085691829622e-08 -0.09995946912938959 -2.7989 0.7070358061118733 0.7070344942593871 -9.686343630486982e-08 -0.09995948143941936 -2.799 0.7070358272865722 0.7070345165984082 -9.723349457101821e-08 -0.09995949374571106 -2.7991 0.7070358484508454 0.7070345389346404 -9.759095013529839e-08 -0.09995950604826585 -2.7992000000000004 0.7070358696048311 0.7070345612679494 -9.793572435055214e-08 -0.09995951834708489 -2.7993 0.7070358907486687 0.7070345835982002 -9.82677415195185e-08 -0.09995953064216928 -2.7994 0.7070359118824977 0.7070346059252564 -9.858692891218102e-08 -0.09995954293352013 -2.7995 0.7070359330064591 0.7070346282489817 -9.889321678484969e-08 -0.09995955522113859 -2.7996000000000003 0.7070359541206941 0.7070346505692386 -9.918653838102837e-08 -0.09995956750502581 -2.7997 0.707035975225345 0.7070346728858892 -9.946682996263972e-08 -0.09995957978518293 -2.7998000000000003 0.7070359963205546 0.7070346951987947 -9.973403081783155e-08 -0.09995959206161109 -2.7999 0.7070360174064663 0.7070347175078155 -9.998808326791564e-08 -0.09995960433431143 -2.8 0.7070360384832237 0.7070347398128123 -1.0022893269252126e-07 -0.09995961660328509 -2.8001000000000005 0.7070360595509715 0.7070347621136441 -1.0045652753046252e-07 -0.09995962886853314 -2.8002000000000002 0.7070360806098545 0.7070347844101698 -1.0067081929188149e-07 -0.09995964113005672 -2.8003 0.7070361016600184 0.7070348067022483 -1.0087176257646269e-07 -0.09995965338785698 -2.8004000000000002 0.7070361227016089 0.7070348289897374 -1.010593150708311e-07 -0.09995966564193506 -2.8005 0.7070361437347723 0.7070348512724947 -1.0123343756763409e-07 -0.09995967789229201 -2.8006 0.7070361647596555 0.707034873550378 -1.0139409397248028e-07 -0.0999596901389291 -2.8007000000000004 0.7070361857764051 0.7070348958232436 -1.0154125130220487e-07 -0.09995970238184734 -2.8008 0.7070362067851694 0.7070349180909486 -1.0167487970221684e-07 -0.09995971462104794 -2.8009 0.7070362277860953 0.7070349403533494 -1.0179495244996839e-07 -0.09995972685653202 -2.801 0.7070362487793311 0.7070349626103016 -1.0190144595322026e-07 -0.09995973908830065 -2.8011000000000004 0.7070362697650248 0.7070349848616614 -1.0199433976652156e-07 -0.09995975131635501 -2.8012 0.7070362907433244 0.7070350071072844 -1.0207361658427089e-07 -0.0999597635406962 -2.8013000000000003 0.7070363117143788 0.707035029347026 -1.0213926224678788e-07 -0.09995977576132536 -2.8014 0.7070363326783361 0.707035051580742 -1.021912657420479e-07 -0.09995978797824359 -2.8015 0.7070363536353453 0.7070350738082873 -1.0222961921609042e-07 -0.09995980019145206 -2.8016000000000005 0.707036374585555 0.7070350960295176 -1.0225431796434536e-07 -0.09995981240095189 -2.8017000000000003 0.7070363955291137 0.707035118244288 -1.0226536042729634e-07 -0.09995982460674416 -2.8018 0.7070364164661702 0.707035140452454 -1.0226274820262365e-07 -0.09995983680883005 -2.8019000000000003 0.7070364373968734 0.7070351626538707 -1.0224648603739811e-07 -0.09995984900721068 -2.802 0.7070364583213715 0.7070351848483937 -1.0221658182374416e-07 -0.09995986120188716 -2.8021000000000003 0.7070364792398129 0.7070352070358785 -1.021730466057788e-07 -0.09995987339286061 -2.8022000000000005 0.707036500152346 0.7070352292161808 -1.0211589456052966e-07 -0.09995988558013214 -2.8023000000000002 0.7070365210591185 0.7070352513891565 -1.020451430031391e-07 -0.09995989776370286 -2.8024 0.7070365419602788 0.707035273554662 -1.0196081239120108e-07 -0.09995990994357397 -2.8025 0.7070365628559737 0.7070352957125534 -1.0186292629613819e-07 -0.0999599221197465 -2.8026000000000004 0.707036583746351 0.7070353178626878 -1.0175151141881417e-07 -0.09995993429222161 -2.8027 0.7070366046315575 0.7070353400049217 -1.0162659756871723e-07 -0.09995994646100043 -2.8028000000000004 0.70703662551174 0.707035362139113 -1.014882176604906e-07 -0.09995995862608412 -2.8029 0.7070366463870444 0.7070353842651194 -1.0133640770699365e-07 -0.09995997078747376 -2.803 0.7070366672576167 0.7070354063827986 -1.0117120681236297e-07 -0.09995998294517047 -2.8031 0.707036688123602 0.70703542849201 -1.0099265715466516e-07 -0.09995999509917541 -2.8032000000000004 0.707036708985145 0.7070354505926122 -1.008008039746211e-07 -0.09996000724948961 -2.8033 0.7070367298423903 0.707035472684465 -1.0059569557300391e-07 -0.09996001939611429 -2.8034 0.7070367506954816 0.7070354947674287 -1.0037738329936319e-07 -0.09996003153905052 -2.8035 0.7070367715445618 0.7070355168413639 -1.0014592152340213e-07 -0.09996004367829936 -2.8036000000000003 0.7070367923897735 0.7070355389061325 -9.990136764451846e-08 -0.09996005581386205 -2.8037 0.7070368132312587 0.707035560961596 -9.964378205277319e-08 -0.09996006794573963 -2.8038000000000003 0.7070368340691585 0.7070355830076176 -9.93732281358295e-08 -0.09996008007393323 -2.8039 0.7070368549036135 0.7070356050440609 -9.908977224252352e-08 -0.09996009219844405 -2.804 0.7070368757347631 0.7070356270707898 -9.879348368980329e-08 -0.09996010431927309 -2.8041000000000005 0.7070368965627466 0.7070356490876697 -9.848443473410573e-08 -0.09996011643642155 -2.8042000000000002 0.7070369173877018 0.707035671094566 -9.816270054967269e-08 -0.0999601285498905 -2.8043 0.7070369382097661 0.7070356930913456 -9.782835921380573e-08 -0.09996014065968106 -2.8044000000000002 0.7070369590290758 0.7070357150778761 -9.748149168951892e-08 -0.09996015276579438 -2.8045 0.7070369798457665 0.7070357370540258 -9.712218180472215e-08 -0.09996016486823152 -2.8046 0.7070370006599727 0.7070357590196643 -9.675051623921072e-08 -0.09996017696699365 -2.8047000000000004 0.707037021471828 0.7070357809746617 -9.636658448910346e-08 -0.09996018906208184 -2.8048 0.7070370422814649 0.7070358029188892 -9.597047885556709e-08 -0.09996020115349719 -2.8049 0.7070370630890153 0.7070358248522199 -9.556229442053005e-08 -0.09996021324124094 -2.805 0.7070370838946094 0.7070358467745268 -9.51421290241311e-08 -0.09996022532531408 -2.8051000000000004 0.707037104698377 0.7070358686856844 -9.471008324043323e-08 -0.0999602374057178 -2.8052 0.707037125500446 0.707035890585568 -9.426626035834162e-08 -0.09996024948245313 -2.8053000000000003 0.7070371463009433 0.7070359124740548 -9.381076634864399e-08 -0.09996026155552123 -2.8054 0.7070371670999955 0.707035934351023 -9.334370984406121e-08 -0.09996027362492325 -2.8055 0.7070371878977271 0.7070359562163512 -9.286520210802229e-08 -0.09996028569066022 -2.8056000000000005 0.7070372086942617 0.7070359780699201 -9.237535701644983e-08 -0.09996029775273335 -2.8057000000000003 0.7070372294897215 0.7070359999116111 -9.18742910274023e-08 -0.09996030981114364 -2.8058 0.7070372502842277 0.7070360217413073 -9.136212314637959e-08 -0.09996032186589228 -2.8059000000000003 0.7070372710779003 0.7070360435588929 -9.083897490984316e-08 -0.0999603339169804 -2.806 0.707037291870857 0.7070360653642535 -9.030497035052154e-08 -0.0999603459644091 -2.8061000000000003 0.7070373126632152 0.707036087157276 -8.976023596531796e-08 -0.09996035800817947 -2.8062000000000005 0.7070373334550906 0.7070361089378485 -8.920490069015685e-08 -0.09996037004829257 -2.8063000000000002 0.7070373542465969 0.7070361307058608 -8.86390958696262e-08 -0.09996038208474955 -2.8064 0.7070373750378474 0.7070361524612043 -8.806295521707891e-08 -0.09996039411755153 -2.8065 0.7070373958289532 0.7070361742037712 -8.747661479728552e-08 -0.09996040614669961 -2.8066000000000004 0.7070374166200242 0.707036195933456 -8.688021298480092e-08 -0.09996041817219496 -2.8067 0.7070374374111686 0.7070362176501541 -8.627389043100453e-08 -0.09996043019403861 -2.8068 0.7070374582024932 0.7070362393537628 -8.565779003461005e-08 -0.09996044221223166 -2.8069 0.7070374789941033 0.7070362610441807 -8.503205690957305e-08 -0.0999604542267753 -2.807 0.7070374997861024 0.7070362827213084 -8.439683834519235e-08 -0.09996046623767059 -2.8071 0.7070375205785924 0.7070363043850472 -8.375228377488497e-08 -0.09996047824491855 -2.8072000000000004 0.7070375413716736 0.7070363260353014 -8.30985447458285e-08 -0.09996049024852047 -2.8073 0.707037562165445 0.7070363476719758 -8.243577487038883e-08 -0.0999605022484773 -2.8074 0.7070375829600034 0.7070363692949774 -8.176412980356873e-08 -0.09996051424479024 -2.8075 0.7070376037554442 0.7070363909042146 -8.108376719443561e-08 -0.09996052623746035 -2.8076000000000003 0.707037624551861 0.7070364124995976 -8.039484666357011e-08 -0.0999605382264887 -2.8077 0.7070376453493459 0.7070364340810389 -7.969752975189176e-08 -0.0999605502118765 -2.8078000000000003 0.7070376661479885 0.7070364556484519 -7.899197989290341e-08 -0.09996056219362477 -2.8079 0.7070376869478776 0.7070364772017526 -7.827836236498631e-08 -0.09996057417173465 -2.808 0.7070377077490997 0.7070364987408579 -7.755684426104248e-08 -0.09996058614620729 -2.8081000000000005 0.7070377285517394 0.7070365202656872 -7.682759444339188e-08 -0.09996059811704366 -2.8082000000000003 0.7070377493558797 0.7070365417761617 -7.609078351254739e-08 -0.09996061008424506 -2.8083 0.7070377701616015 0.707036563272204 -7.534658375430575e-08 -0.0999606220478124 -2.8084000000000002 0.7070377909689838 0.7070365847537388 -7.459516911459407e-08 -0.09996063400774687 -2.8085 0.7070378117781043 0.7070366062206928 -7.383671514482604e-08 -0.0999606459640496 -2.8086 0.7070378325890379 0.7070366276729942 -7.307139896894216e-08 -0.09996065791672158 -2.8087000000000004 0.7070378534018585 0.7070366491105743 -7.229939924394482e-08 -0.09996066986576406 -2.8088 0.7070378742166374 0.7070366705333646 -7.152089610872395e-08 -0.09996068181117802 -2.8089 0.7070378950334439 0.7070366919413 -7.073607115239827e-08 -0.09996069375296458 -2.809 0.7070379158523459 0.7070367133343167 -6.994510736444207e-08 -0.09996070569112492 -2.8091000000000004 0.7070379366734088 0.707036734712353 -6.914818909825593e-08 -0.09996071762566008 -2.8092 0.7070379574966965 0.7070367560753494 -6.834550202389558e-08 -0.09996072955657123 -2.8093000000000004 0.7070379783222702 0.7070367774232478 -6.753723308687218e-08 -0.09996074148385939 -2.8094 0.7070379991501898 0.7070367987559926 -6.672357046044741e-08 -0.09996075340752567 -2.8095 0.7070380199805129 0.7070368200735302 -6.590470350920433e-08 -0.09996076532757117 -2.8096000000000005 0.7070380408132945 0.7070368413758088 -6.508082273830665e-08 -0.09996077724399699 -2.8097000000000003 0.7070380616485883 0.7070368626627794 -6.425211975403383e-08 -0.09996078915680427 -2.8098 0.7070380824864455 0.7070368839343943 -6.341878721781088e-08 -0.09996080106599407 -2.8099000000000003 0.7070381033269155 0.7070369051906078 -6.258101879503403e-08 -0.09996081297156743 -2.81 0.7070381241700459 0.707036926431377 -6.17390091208099e-08 -0.09996082487352564 -2.8101000000000003 0.7070381450158811 0.7070369476566607 -6.089295374921491e-08 -0.09996083677186964 -2.8102000000000005 0.7070381658644644 0.7070369688664198 -6.00430491086261e-08 -0.09996084866660054 -2.8103000000000002 0.7070381867158365 0.707036990060617 -5.918949245358254e-08 -0.09996086055771947 -2.8104 0.7070382075700361 0.7070370112392179 -5.833248182358572e-08 -0.0999608724452275 -2.8105 0.7070382284271 0.7070370324021895 -5.747221599300932e-08 -0.09996088432912575 -2.8106000000000004 0.7070382492870623 0.7070370535495014 -5.660889443076696e-08 -0.0999608962094153 -2.8107 0.7070382701499552 0.7070370746811251 -5.574271724610204e-08 -0.0999609080860972 -2.8108 0.7070382910158093 0.7070370957970344 -5.487388514803862e-08 -0.09996091995917264 -2.8109 0.7070383118846522 0.7070371168972054 -5.400259939745966e-08 -0.09996093182864264 -2.811 0.70703833275651 0.7070371379816162 -5.312906175983581e-08 -0.09996094369450839 -2.8111 0.7070383536314058 0.7070371590502468 -5.225347445882156e-08 -0.0999609555567709 -2.8112000000000004 0.7070383745093615 0.7070371801030797 -5.137604013006822e-08 -0.09996096741543128 -2.8113 0.7070383953903963 0.7070372011400995 -5.0496961773952714e-08 -0.09996097927049065 -2.8114 0.7070384162745271 0.7070372221612928 -4.961644270863163e-08 -0.09996099112195003 -2.8115 0.7070384371617686 0.7070372431666492 -4.8734686522878407e-08 -0.09996100296981057 -2.8116000000000003 0.7070384580521337 0.7070372641561593 -4.7851897028161616e-08 -0.09996101481407332 -2.8117 0.7070384789456329 0.7070372851298168 -4.6968278213542144e-08 -0.09996102665473944 -2.8118000000000003 0.7070384998422745 0.707037306087617 -4.6084034197046726e-08 -0.09996103849181 -2.8119 0.7070385207420649 0.7070373270295579 -4.519936918018566e-08 -0.09996105032528607 -2.812 0.7070385416450072 0.7070373479556391 -4.431448739845899e-08 -0.0999610621551687 -2.8121000000000005 0.707038562551104 0.7070373688658632 -4.342959307469514e-08 -0.09996107398145909 -2.8122000000000003 0.7070385834603543 0.7070373897602344 -4.2544890374676567e-08 -0.09996108580415826 -2.8123 0.7070386043727559 0.7070374106387591 -4.1660583356931016e-08 -0.09996109762326737 -2.8124000000000002 0.7070386252883034 0.7070374315014463 -4.077687592712051e-08 -0.09996110943878742 -2.8125 0.70703864620699 0.7070374523483064 -3.989397179032968e-08 -0.09996112125071951 -2.8126 0.7070386671288065 0.707037473179353 -3.901207440307284e-08 -0.09996113305906479 -2.8127000000000004 0.7070386880537414 0.7070374939946006 -3.813138693133881e-08 -0.09996114486382424 -2.8128 0.7070387089817808 0.7070375147940673 -3.725211219867113e-08 -0.099961156664999 -2.8129 0.7070387299129095 0.7070375355777727 -3.637445263916794e-08 -0.09996116846259022 -2.813 0.7070387508471092 0.7070375563457383 -3.5498610255848585e-08 -0.09996118025659889 -2.8131000000000004 0.7070387717843601 0.7070375770979882 -3.462478656980454e-08 -0.0999611920470262 -2.8132 0.7070387927246399 0.7070375978345488 -3.3753182574446094e-08 -0.09996120383387322 -2.8133000000000004 0.7070388136679238 0.7070376185554478 -3.288399869202582e-08 -0.09996121561714094 -2.8134 0.7070388346141856 0.707037639260716 -3.20174347243074e-08 -0.09996122739683057 -2.8135 0.7070388555633966 0.7070376599503859 -3.115368980865542e-08 -0.09996123917294314 -2.8136000000000005 0.7070388765155257 0.707037680624492 -3.029296237076415e-08 -0.0999612509454797 -2.8137000000000003 0.7070388974705399 0.7070377012830712 -2.9435450080205275e-08 -0.09996126271444133 -2.8138 0.7070389184284045 0.7070377219261621 -2.8581349804457715e-08 -0.09996127447982917 -2.8139000000000003 0.7070389393890824 0.7070377425538064 -2.773085756510585e-08 -0.09996128624164431 -2.814 0.7070389603525338 0.7070377631660464 -2.688416849186935e-08 -0.09996129799988779 -2.8141000000000003 0.7070389813187177 0.7070377837629276 -2.6041476776633016e-08 -0.09996130975456069 -2.8142000000000005 0.7070390022875908 0.7070378043444977 -2.5202975631813396e-08 -0.09996132150566418 -2.8143000000000002 0.7070390232591074 0.7070378249108055 -2.4368857242003383e-08 -0.09996133325319928 -2.8144 0.70703904423322 0.7070378454619026 -2.3539312725157774e-08 -0.09996134499716708 -2.8145 0.7070390652098791 0.7070378659978422 -2.2714532081202082e-08 -0.09996135673756867 -2.8146000000000004 0.7070390861890328 0.70703788651868 -2.1894704158639117e-08 -0.09996136847440507 -2.8147 0.707039107170628 0.7070379070244734 -2.1080016602507273e-08 -0.09996138020767747 -2.8148 0.7070391281546085 0.7070379275152816 -2.0270655818818706e-08 -0.09996139193738686 -2.8149 0.7070391491409168 0.7070379479911664 -1.946680692251762e-08 -0.09996140366353436 -2.815 0.7070391701294936 0.7070379684521908 -1.8668653704954213e-08 -0.09996141538612105 -2.8151 0.7070391911202772 0.7070379888984205 -1.7876378587480812e-08 -0.09996142710514799 -2.8152000000000004 0.7070392121132043 0.7070380093299227 -1.7090162578083795e-08 -0.09996143882061634 -2.8153 0.7070392331082093 0.7070380297467667 -1.631018523365335e-08 -0.09996145053252709 -2.8154 0.7070392541052248 0.7070380501490233 -1.5536624614446992e-08 -0.09996146224088132 -2.8155 0.7070392751041819 0.707038070536766 -1.4769657248094037e-08 -0.09996147394568018 -2.8156000000000003 0.7070392961050089 0.7070380909100695 -1.400945808709489e-08 -0.0999614856469247 -2.8157 0.7070393171076337 0.7070381112690105 -1.3256200471090801e-08 -0.09996149734461598 -2.8158000000000003 0.7070393381119808 0.7070381316136678 -1.2510056082628424e-08 -0.09996150903875509 -2.8159 0.7070393591179738 0.7070381519441216 -1.1771194912031657e-08 -0.09996152072934306 -2.816 0.7070393801255344 0.7070381722604544 -1.1039785219237735e-08 -0.09996153241638106 -2.8161000000000005 0.7070394011345823 0.7070381925627498 -1.0315993492597542e-08 -0.0999615440998701 -2.8162000000000003 0.7070394221450353 0.7070382128510938 -9.599984413313778e-09 -0.0999615557798112 -2.8163 0.7070394431568101 0.7070382331255742 -8.891920814241283e-09 -0.09996156745620559 -2.8164000000000002 0.707039464169821 0.7070382533862801 -8.191963651697776e-09 -0.09996157912905428 -2.8165 0.7070394851839812 0.7070382736333025 -7.500271955590554e-09 -0.09996159079835835 -2.8166 0.7070395061992014 0.7070382938667339 -6.8170028025282825e-09 -0.09996160246411888 -2.8167000000000004 0.7070395272153911 0.7070383140866687 -6.142311284595969e-09 -0.09996161412633689 -2.8168 0.7070395482324585 0.707038334293203 -5.476350459047985e-09 -0.09996162578501355 -2.8169 0.7070395692503095 0.7070383544864338 -4.8192713266240195e-09 -0.09996163744014984 -2.817 0.7070395902688489 0.7070383746664608 -4.171222793385165e-09 -0.09996164909174686 -2.8171000000000004 0.7070396112879798 0.7070383948333845 -3.5323516334173632e-09 -0.09996166073980568 -2.8172 0.7070396323076036 0.7070384149873071 -2.9028024645452732e-09 -0.0999616723843274 -2.8173000000000004 0.7070396533276204 0.7070384351283328 -2.2827177058315495e-09 -0.09996168402531312 -2.8174 0.7070396743479288 0.7070384552565667 -1.6722375506886267e-09 -0.0999616956627639 -2.8175 0.7070396953684255 0.7070384753721155 -1.0714999339189735e-09 -0.09996170729668075 -2.8176000000000005 0.7070397163890063 0.7070384954750875 -4.806404978879852e-10 -0.09996171892706482 -2.8177000000000003 0.7070397374095652 0.7070385155655923 1.0020742829269791e-10 -0.0999617305539171 -2.8178 0.707039758429995 0.7070385356437411 6.70912872133278e-10 -0.09996174217723876 -2.8179000000000003 0.7070397794501868 0.7070385557096464 1.231347241184566e-09 -0.0999617537970308 -2.818 0.7070398004700309 0.7070385757634216 1.7813843490588344e-09 -0.0999617654132943 -2.8181000000000003 0.7070398214894159 0.7070385958051821 2.32090044231803e-09 -0.09996177702603032 -2.8182000000000005 0.7070398425082292 0.7070386158350445 2.8497742421071393e-09 -0.09996178863523998 -2.8183000000000002 0.7070398635263564 0.7070386358531262 3.3678869545625267e-09 -0.0999618002409243 -2.8184 0.7070398845436832 0.7070386558595463 3.87512230724113e-09 -0.09996181184308442 -2.8185 0.7070399055600927 0.7070386758544253 4.3713665673350555e-09 -0.09996182344172139 -2.8186000000000004 0.7070399265754674 0.7070386958378838 4.856508585039665e-09 -0.09996183503683621 -2.8187 0.7070399475896888 0.7070387158100447 5.330439793553576e-09 -0.09996184662843004 -2.8188 0.7070399686026367 0.7070387357710315 5.793054250712026e-09 -0.09996185821650386 -2.8189 0.7070399896141903 0.7070387557209692 6.244248657201468e-09 -0.09996186980105881 -2.819 0.7070400106242278 0.7070387756599834 6.683922379110974e-09 -0.09996188138209594 -2.8191 0.7070400316326255 0.7070387955882009 7.111977469616282e-09 -0.09996189295961627 -2.8192000000000004 0.70704005263926 0.7070388155057499 7.528318700204817e-09 -0.09996190453362093 -2.8193 0.7070400736440055 0.7070388354127588 7.932853558073605e-09 -0.09996191610411091 -2.8194 0.7070400946467363 0.7070388553093578 8.325492296436254e-09 -0.09996192767108732 -2.8195 0.7070401156473258 0.7070388751956775 8.70614793625768e-09 -0.09996193923455131 -2.8196000000000003 0.7070401366456456 0.7070388950718498 9.074736286203422e-09 -0.09996195079450382 -2.8197 0.707040157641567 0.707038914938007 9.431175972129946e-09 -0.099961962350946 -2.8198000000000003 0.7070401786349607 0.7070389347942825 9.775388443156174e-09 -0.0999619739038789 -2.8199 0.7070401996256961 0.7070389546408105 1.0107297989010722e-08 -0.09996198545330355 -2.82 0.7070402206136419 0.7070389744777257 1.0426831771256917e-08 -0.09996199699922104 -2.8201000000000005 0.7070402415986662 0.7070389943051641 1.0733919818088633e-08 -0.0999620085416324 -2.8202000000000003 0.7070402625806365 0.707039014123262 1.1028495053820586e-08 -0.0999620200805387 -2.8203 0.7070402835594194 0.7070390339321567 1.131049331623557e-08 -0.09996203161594108 -2.8204000000000002 0.7070403045348808 0.7070390537319855 1.1579853355717096e-08 -0.09996204314784052 -2.8205 0.7070403255068863 0.7070390735228873 1.1836516858668156e-08 -0.09996205467623814 -2.8206 0.7070403464753008 0.7070390933050008 1.2080428462256376e-08 -0.09996206620113499 -2.8207000000000004 0.7070403674399881 0.7070391130784653 1.2311535763087633e-08 -0.09996207772253207 -2.8208 0.7070403884008123 0.7070391328434213 1.2529789322410223e-08 -0.09996208924043057 -2.8209 0.7070404093576362 0.7070391526000092 1.2735142688666268e-08 -0.09996210075483139 -2.821 0.707040430310323 0.7070391723483695 1.2927552396624353e-08 -0.09996211226573569 -2.8211000000000004 0.7070404512587352 0.7070391920886441 1.3106977981257317e-08 -0.09996212377314453 -2.8212 0.7070404722027339 0.7070392118209747 1.3273381986415866e-08 -0.09996213527705894 -2.8213000000000004 0.7070404931421814 0.7070392315455036 1.3426729968298023e-08 -0.09996214677748 -2.8214 0.7070405140769387 0.7070392512623733 1.3566990510194277e-08 -0.09996215827440876 -2.8215 0.7070405350068666 0.7070392709717265 1.3694135221620218e-08 -0.09996216976784628 -2.8216000000000006 0.7070405559318262 0.7070392906737062 1.3808138749592247e-08 -0.09996218125779366 -2.8217000000000003 0.7070405768516776 0.707039310368456 1.3908978773423397e-08 -0.09996219274425193 -2.8218 0.707040597766281 0.7070393300561192 1.3996636023805298e-08 -0.09996220422722214 -2.8219000000000003 0.7070406186754967 0.7070393497368397 1.4071094281073449e-08 -0.09996221570670538 -2.822 0.7070406395791842 0.7070393694107611 1.4132340367400964e-08 -0.09996222718270265 -2.8221000000000003 0.7070406604772037 0.7070393890780273 1.4180364161543724e-08 -0.09996223865521506 -2.8222000000000005 0.7070406813694147 0.7070394087387826 1.4215158597105648e-08 -0.09996225012424363 -2.8223000000000003 0.7070407022556771 0.7070394283931705 1.42367196625387e-08 -0.09996226158978944 -2.8224 0.7070407231358506 0.7070394480413356 1.4245046396806071e-08 -0.09996227305185358 -2.8225 0.707040744009795 0.7070394676834213 1.4240140891116915e-08 -0.09996228451043704 -2.8226000000000004 0.7070407648773698 0.7070394873195722 1.4222008299334676e-08 -0.0999622959655409 -2.8227 0.7070407857384349 0.7070395069499318 1.4190656810221525e-08 -0.09996230741716623 -2.8228 0.7070408065928505 0.7070395265746439 1.4146097674326563e-08 -0.09996231886531409 -2.8229 0.7070408274404767 0.7070395461938523 1.4088345174495531e-08 -0.09996233030998554 -2.823 0.707040848281174 0.7070395658077 1.4017416644952763e-08 -0.09996234175118163 -2.8231 0.7070408691148028 0.70703958541633 1.3933332446147695e-08 -0.09996235318890337 -2.8232000000000004 0.7070408899412239 0.7070396050198859 1.3836115970826401e-08 -0.09996236462315188 -2.8233 0.7070409107602986 0.7070396246185097 1.3725793629286442e-08 -0.09996237605392816 -2.8234 0.707040931571888 0.7070396442123437 1.360239485718312e-08 -0.09996238748123325 -2.8235 0.7070409523758543 0.7070396638015302 1.3465952092110711e-08 -0.09996239890506826 -2.8236000000000003 0.7070409731720595 0.7070396833862103 1.3316500766663575e-08 -0.09996241032543424 -2.8237 0.7070409939603661 0.7070397029665256 1.3154079311905598e-08 -0.09996242174233225 -2.8238000000000003 0.7070410147406376 0.7070397225426168 1.2978729139155598e-08 -0.09996243315576334 -2.8239 0.7070410355127371 0.7070397421146237 1.27904946269769e-08 -0.09996244456572854 -2.824 0.7070410562765289 0.7070397616826862 1.2589423115105802e-08 -0.09996245597222896 -2.8241000000000005 0.7070410770318774 0.707039781246943 1.2375564890573787e-08 -0.09996246737526551 -2.8242000000000003 0.7070410977786474 0.7070398008075331 1.2148973172095012e-08 -0.09996247877483931 -2.8243 0.7070411185167051 0.7070398203645945 1.190970410486214e-08 -0.09996249017095146 -2.8244000000000002 0.707041139245917 0.7070398399182644 1.165781673799493e-08 -0.09996250156360299 -2.8245 0.7070411599661501 0.7070398594686791 1.139337301760135e-08 -0.0999625129527949 -2.8246 0.7070411806772721 0.7070398790159751 1.1116437766828247e-08 -0.09996252433852833 -2.8247000000000004 0.7070412013791514 0.7070398985602873 1.0827078665912038e-08 -0.09996253572080425 -2.8248 0.7070412220716575 0.7070399181017502 1.0525366245239809e-08 -0.09996254709962375 -2.8249 0.7070412427546605 0.7070399376404976 1.021137386626736e-08 -0.09996255847498793 -2.825 0.7070412634280311 0.7070399571766619 9.885177698967795e-09 -0.09996256984689772 -2.8251000000000004 0.7070412840916411 0.7070399767103756 9.546856707953744e-09 -0.09996258121535428 -2.8252 0.7070413047453634 0.7070399962417693 9.196492629925945e-09 -0.09996259258035858 -2.8253000000000004 0.7070413253890709 0.7070400157709733 8.834169952856574e-09 -0.09996260394191168 -2.8254 0.7070413460226388 0.707040035298117 8.459975900376726e-09 -0.09996261530001468 -2.8255 0.7070413666459417 0.7070400548233284 8.074000409225013e-09 -0.09996262665466854 -2.8256000000000006 0.7070413872588569 0.7070400743467351 7.67633610756352e-09 -0.09996263800587436 -2.8257000000000003 0.7070414078612612 0.7070400938684633 7.267078287222228e-09 -0.0999626493536332 -2.8258 0.7070414284530335 0.7070401133886377 6.846324892423317e-09 -0.09996266069794607 -2.8259000000000003 0.7070414490340535 0.707040132907383 6.41417648682141e-09 -0.09996267203881407 -2.826 0.7070414696042018 0.7070401524248218 5.970736232686902e-09 -0.0999626833762382 -2.8261000000000003 0.7070414901633602 0.7070401719410759 5.5161098674871845e-09 -0.09996269471021951 -2.8262000000000005 0.7070415107114119 0.7070401914562662 5.050405676998437e-09 -0.09996270604075908 -2.8263000000000003 0.7070415312482408 0.7070402109705117 4.573734469284774e-09 -0.09996271736785786 -2.8264 0.7070415517737325 0.7070402304839313 4.08620954954475e-09 -0.099962728691517 -2.8265 0.7070415722877739 0.7070402499966417 3.5879466923557923e-09 -0.09996274001173752 -2.8266000000000004 0.7070415927902525 0.7070402695087588 3.0790641147859787e-09 -0.09996275132852042 -2.8267 0.7070416132810582 0.7070402890203966 2.559682449505829e-09 -0.0999627626418668 -2.8268 0.707041633760081 0.7070403085316685 2.0299247135632803e-09 -0.09996277395177766 -2.8269 0.7070416542272131 0.707040328042686 1.4899162797607501e-09 -0.09996278525825401 -2.827 0.707041674682348 0.70704034755356 9.397848488995608e-10 -0.09996279656129703 -2.8271 0.7070416951253803 0.707040367064399 3.7966041855491683e-10 -0.09996280786090762 -2.8272000000000004 0.7070417155562059 0.7070403865753107 -1.903247455470325e-10 -0.0999628191570869 -2.8273 0.7070417359747226 0.7070404060864013 -7.700361468257477e-10 -0.0999628304498359 -2.8274 0.7070417563808294 0.7070404255977751 -1.3593370812650662e-09 -0.09996284173915562 -2.8275 0.7070417767744269 0.7070404451095356 -1.9580886773118422e-09 -0.09996285302504714 -2.8276000000000003 0.7070417971554173 0.707040464621784 -2.566149924498884e-09 -0.09996286430751149 -2.8277 0.7070418175237039 0.7070404841346207 -3.183377702067891e-09 -0.09996287558654968 -2.8278000000000003 0.7070418378791921 0.7070405036481442 -3.8096268232049035e-09 -0.09996288686216283 -2.8279 0.7070418582217883 0.7070405231624513 -4.444750062795877e-09 -0.09996289813435189 -2.828 0.7070418785514012 0.7070405426776372 -5.088598195590599e-09 -0.09996290940311789 -2.8281000000000005 0.707041898867941 0.7070405621937959 -5.741020023090904e-09 -0.099962920668462 -2.8282000000000003 0.7070419191713189 0.7070405817110191 -6.401862419520843e-09 -0.09996293193038515 -2.8283 0.7070419394614487 0.7070406012293974 -7.070970356980177e-09 -0.09996294318888842 -2.8284000000000002 0.7070419597382449 0.7070406207490193 -7.748186953149272e-09 -0.09996295444397284 -2.8285 0.7070419800016245 0.7070406402699719 -8.433353501646756e-09 -0.09996296569563941 -2.8286000000000002 0.7070420002515059 0.7070406597923404 -9.126309506723995e-09 -0.09996297694388923 -2.8287000000000004 0.7070420204878092 0.7070406793162084 -9.826892725765812e-09 -0.0999629881887233 -2.8288 0.7070420407104558 0.7070406988416575 -1.0534939209189131e-08 -0.09996299943014264 -2.8289 0.7070420609193706 0.7070407183687677 -1.1250283329065913e-08 -0.09996301066814836 -2.829 0.7070420811144783 0.7070407378976171 -1.1972757828562774e-08 -0.09996302190274141 -2.8291000000000004 0.7070421012957062 0.7070407574282818 -1.2702193853599691e-08 -0.0999630331339228 -2.8292 0.7070421214629841 0.7070407769608367 -1.3438420998386491e-08 -0.09996304436169372 -2.8293000000000004 0.7070421416162425 0.7070407964953542 -1.4181267340984682e-08 -0.09996305558605509 -2.8294 0.7070421617554141 0.7070408160319055 -1.493055947973665e-08 -0.09996306680700798 -2.8295 0.7070421818804342 0.707040835570559 -1.5686122584873674e-08 -0.09996307802455341 -2.8296000000000006 0.7070422019912391 0.7070408551113817 -1.644778042930728e-08 -0.0999630892386924 -2.8297000000000003 0.7070422220877676 0.7070408746544388 -1.721535543416572e-08 -0.09996310044942598 -2.8298 0.7070422421699598 0.7070408941997937 -1.798866870999366e-08 -0.09996311165675521 -2.8299000000000003 0.7070422622377583 0.7070409137475072 -1.8767540096217145e-08 -0.0999631228606811 -2.83 0.7070422822911079 0.7070409332976391 -1.9551788204945353e-08 -0.09996313406120473 -2.8301000000000003 0.7070423023299544 0.7070409528502464 -2.0341230464338694e-08 -0.09996314525832709 -2.8302000000000005 0.7070423223542464 0.7070409724053842 -2.1135683157206403e-08 -0.09996315645204921 -2.8303000000000003 0.707042342363934 0.7070409919631064 -2.1934961468711434e-08 -0.09996316764237219 -2.8304 0.7070423623589699 0.7070410115234642 -2.273887952496806e-08 -0.099963178829297 -2.8305 0.7070423823393079 0.7070410310865065 -2.3547250436409956e-08 -0.09996319001282467 -2.8306000000000004 0.7070424023049048 0.7070410506522812 -2.435988634506142e-08 -0.09996320119295626 -2.8307 0.7070424222557186 0.707041070220833 -2.5176598467471778e-08 -0.09996321236969274 -2.8308 0.7070424421917096 0.7070410897922057 -2.599719713287929e-08 -0.09996322354303522 -2.8309 0.7070424621128406 0.7070411093664404 -2.682149183525287e-08 -0.09996323471298468 -2.831 0.7070424820190757 0.707041128943576 -2.764929127123915e-08 -0.09996324587954215 -2.8311 0.7070425019103821 0.7070411485236496 -2.8480403386349495e-08 -0.09996325704270871 -2.8312000000000004 0.7070425217867278 0.7070411681066964 -2.931463542288175e-08 -0.09996326820248534 -2.8313 0.7070425416480836 0.7070411876927492 -3.01517939600357e-08 -0.09996327935887304 -2.8314 0.7070425614944225 0.707041207281839 -3.0991684960967464e-08 -0.0999632905118729 -2.8315 0.7070425813257195 0.7070412268739945 -3.183411381767545e-08 -0.09996330166148598 -2.8316000000000003 0.7070426011419515 0.7070412464692422 -3.2678885392850576e-08 -0.09996331280771324 -2.8317 0.7070426209430972 0.7070412660676069 -3.352580407170111e-08 -0.09996332395055571 -2.8318000000000003 0.7070426407291382 0.7070412856691106 -3.4374673799682925e-08 -0.09996333509001444 -2.8319 0.7070426605000577 0.7070413052737741 -3.52252981356254e-08 -0.09996334622609046 -2.832 0.7070426802558412 0.7070413248816155 -3.607748029000376e-08 -0.0999633573587848 -2.8321000000000005 0.7070426999964757 0.7070413444926509 -3.693102317524604e-08 -0.09996336848809843 -2.8322000000000003 0.7070427197219515 0.7070413641068942 -3.778572944920962e-08 -0.09996337961403244 -2.8323 0.70704273943226 0.7070413837243572 -3.864140156115137e-08 -0.0999633907365878 -2.8324000000000003 0.7070427591273953 0.7070414033450496 -3.9497841796505215e-08 -0.09996340185576559 -2.8325 0.7070427788073537 0.7070414229689793 -4.0354852325345976e-08 -0.09996341297156686 -2.8326000000000002 0.7070427984721326 0.7070414425961516 -4.121223524472745e-08 -0.09996342408399257 -2.8327000000000004 0.7070428181217328 0.7070414622265697 -4.206979262695652e-08 -0.09996343519304374 -2.8328 0.7070428377561567 0.7070414818602351 -4.292732656228362e-08 -0.09996344629872146 -2.8329 0.7070428573754087 0.7070415014971467 -4.378463920841688e-08 -0.0999634574010267 -2.833 0.7070428769794956 0.7070415211373017 -4.4641532833029646e-08 -0.09996346849996054 -2.8331000000000004 0.7070428965684257 0.7070415407806947 -4.549780986128917e-08 -0.09996347959552392 -2.8332 0.7070429161422103 0.7070415604273184 -4.635327291945511e-08 -0.09996349068771787 -2.8333000000000004 0.7070429357008622 0.7070415800771637 -4.720772488203554e-08 -0.09996350177654346 -2.8334 0.7070429552443966 0.7070415997302186 -4.8060968917194684e-08 -0.09996351286200171 -2.8335 0.7070429747728308 0.7070416193864699 -4.891280853079865e-08 -0.0999635239440936 -2.8336000000000006 0.7070429942861842 0.7070416390459021 -4.9763047611870587e-08 -0.09996353502282024 -2.8337000000000003 0.7070430137844783 0.707041658708497 -5.0611490479374015e-08 -0.0999635460981826 -2.8338 0.7070430332677361 0.7070416783742347 -5.1457941925743544e-08 -0.09996355717018167 -2.8339000000000003 0.7070430527359839 0.7070416980430934 -5.2302207261337164e-08 -0.09996356823881852 -2.834 0.7070430721892489 0.7070417177150486 -5.314409236159903e-08 -0.09996357930409414 -2.8341000000000003 0.707043091627561 0.7070417373900744 -5.398340370880127e-08 -0.0999635903660095 -2.8342 0.7070431110509521 0.7070417570681429 -5.481994843812253e-08 -0.09996360142456576 -2.8343000000000003 0.7070431304594561 0.707041776749223 -5.5653534381232966e-08 -0.0999636124797638 -2.8344 0.7070431498531089 0.7070417964332829 -5.648397010944543e-08 -0.09996362353160469 -2.8345 0.7070431692319488 0.7070418161202883 -5.7311064982070933e-08 -0.0999636345800895 -2.8346000000000005 0.7070431885960153 0.7070418358102023 -5.8134629185666725e-08 -0.09996364562521917 -2.8347 0.7070432079453514 0.7070418555029867 -5.895447377762125e-08 -0.09996365666699482 -2.8348 0.7070432272800005 0.7070418751986012 -5.977041073234116e-08 -0.09996366770541738 -2.8349 0.7070432466000086 0.7070418948970028 -6.058225298245096e-08 -0.0999636787404879 -2.835 0.707043265905424 0.7070419145981474 -6.138981446324535e-08 -0.09996368977220735 -2.8351 0.7070432851962971 0.7070419343019883 -6.219291015258782e-08 -0.09996370080057684 -2.8352000000000004 0.7070433044726794 0.7070419540084771 -6.299135611471246e-08 -0.0999637118255973 -2.8353 0.7070433237346253 0.7070419737175635 -6.378496954272464e-08 -0.09996372284726977 -2.8354 0.7070433429821905 0.7070419934291947 -6.457356880066809e-08 -0.09996373386559528 -2.8355 0.7070433622154331 0.7070420131433168 -6.535697346602559e-08 -0.0999637448805748 -2.8356000000000003 0.7070433814344128 0.7070420328598739 -6.613500436614822e-08 -0.09996375589220946 -2.8357 0.7070434006391915 0.7070420525788069 -6.690748362379179e-08 -0.09996376690050013 -2.8358000000000003 0.7070434198298328 0.7070420723000566 -6.767423469831654e-08 -0.09996377790544793 -2.8359 0.7070434390064022 0.7070420920235605 -6.84350824216827e-08 -0.09996378890705387 -2.836 0.7070434581689669 0.7070421117492554 -6.918985304398689e-08 -0.09996379990531892 -2.8361000000000005 0.7070434773175964 0.7070421314770753 -6.993837426728933e-08 -0.09996381090024414 -2.8362000000000003 0.7070434964523613 0.7070421512069527 -7.068047529071655e-08 -0.09996382189183049 -2.8363 0.7070435155733348 0.7070421709388185 -7.141598684342124e-08 -0.099963832880079 -2.8364000000000003 0.7070435346805919 0.7070421906726014 -7.214474122578182e-08 -0.09996384386499071 -2.8365 0.7070435537742082 0.7070422104082287 -7.286657235320432e-08 -0.09996385484656657 -2.8366000000000002 0.7070435728542623 0.7070422301456256 -7.358131578431154e-08 -0.09996386582480764 -2.8367000000000004 0.7070435919208345 0.707042249884716 -7.428880876387753e-08 -0.09996387679971497 -2.8368 0.7070436109740061 0.7070422696254216 -7.498889026012409e-08 -0.09996388777128946 -2.8369 0.7070436300138605 0.7070422893676627 -7.56814009989816e-08 -0.09996389873953221 -2.837 0.7070436490404832 0.7070423091113579 -7.63661835000845e-08 -0.09996390970444431 -2.8371000000000004 0.7070436680539605 0.7070423288564238 -7.70430821136342e-08 -0.09996392066602665 -2.8372 0.7070436870543807 0.7070423486027759 -7.771194306376711e-08 -0.09996393162428024 -2.8373000000000004 0.7070437060418342 0.7070423683503273 -7.837261446416721e-08 -0.09996394257920611 -2.8374 0.7070437250164121 0.7070423880989903 -7.902494637140878e-08 -0.09996395353080527 -2.8375 0.7070437439782083 0.7070424078486752 -7.966879081010986e-08 -0.09996396447907878 -2.8376000000000006 0.7070437629273171 0.7070424275992907 -8.03040018110962e-08 -0.09996397542402757 -2.8377000000000003 0.7070437818638348 0.7070424473507441 -8.093043543482004e-08 -0.09996398636565268 -2.8378 0.7070438007878594 0.7070424671029412 -8.154794981559549e-08 -0.09996399730395514 -2.8379000000000003 0.7070438196994902 0.7070424868557861 -8.215640518588474e-08 -0.09996400823893592 -2.838 0.707043838598828 0.7070425066091813 -8.275566391099248e-08 -0.09996401917059605 -2.8381000000000003 0.7070438574859752 0.7070425263630288 -8.334559051942358e-08 -0.09996403009893658 -2.8382 0.7070438763610354 0.7070425461172282 -8.392605173844492e-08 -0.09996404102395849 -2.8383000000000003 0.7070438952241136 0.7070425658716777 -8.449691651403468e-08 -0.09996405194566275 -2.8384 0.7070439140753164 0.7070425856262748 -8.505805604991368e-08 -0.09996406286405041 -2.8385 0.7070439329147513 0.7070426053809147 -8.560934382922936e-08 -0.09996407377912242 -2.8386000000000005 0.7070439517425278 0.7070426251354924 -8.615065564838292e-08 -0.09996408469087989 -2.8387000000000002 0.7070439705587563 0.7070426448899004 -8.668186964391755e-08 -0.0999640955993237 -2.8388 0.7070439893635485 0.7070426646440309 -8.720286631680452e-08 -0.09996410650445492 -2.8389 0.7070440081570175 0.7070426843977744 -8.771352856713766e-08 -0.09996411740627459 -2.839 0.7070440269392773 0.7070427041510203 -8.821374170974589e-08 -0.09996412830478363 -2.8391 0.7070440457104433 0.7070427239036564 -8.870339350194878e-08 -0.09996413919998309 -2.8392000000000004 0.7070440644706322 0.7070427436555704 -8.918237417998576e-08 -0.09996415009187401 -2.8393 0.7070440832199619 0.7070427634066474 -8.96505764676897e-08 -0.09996416098045738 -2.8394 0.7070441019585512 0.7070427831567723 -9.010789561551824e-08 -0.09996417186573416 -2.8395 0.7070441206865201 0.7070428029058287 -9.055422941356417e-08 -0.09996418274770541 -2.8396000000000003 0.7070441394039892 0.7070428226536991 -9.098947821497422e-08 -0.09996419362637206 -2.8397 0.7070441581110811 0.7070428424002648 -9.141354496543935e-08 -0.09996420450173517 -2.8398000000000003 0.7070441768079185 0.707042862145407 -9.182633521880729e-08 -0.09996421537379577 -2.8399 0.7070441954946256 0.7070428818890047 -9.222775715442971e-08 -0.0999642262425548 -2.84 0.7070442141713275 0.7070429016309361 -9.261772160838733e-08 -0.09996423710801328 -2.8401000000000005 0.7070442328381499 0.7070429213710794 -9.299614208389817e-08 -0.09996424797017221 -2.8402000000000003 0.7070442514952197 0.7070429411093107 -9.336293477300167e-08 -0.09996425882903254 -2.8403 0.7070442701426647 0.7070429608455064 -9.371801857997741e-08 -0.09996426968459542 -2.8404000000000003 0.7070442887806134 0.7070429805795415 -9.406131513088611e-08 -0.09996428053686174 -2.8405 0.707044307409195 0.7070430003112902 -9.439274879785575e-08 -0.09996429138583252 -2.8406000000000002 0.7070443260285397 0.7070430200406256 -9.471224671469408e-08 -0.09996430223150876 -2.8407000000000004 0.7070443446387784 0.7070430397674207 -9.50197387890317e-08 -0.09996431307389148 -2.8408 0.7070443632400425 0.7070430594915472 -9.531515771880189e-08 -0.09996432391298163 -2.8409 0.7070443818324648 0.7070430792128766 -9.559843900958792e-08 -0.0999643347487803 -2.841 0.7070444004161773 0.7070430989312794 -9.586952098416396e-08 -0.09996434558128836 -2.8411000000000004 0.7070444189913141 0.7070431186466255 -9.612834480331178e-08 -0.09996435641050688 -2.8412 0.7070444375580094 0.7070431383587845 -9.637485446668814e-08 -0.0999643672364369 -2.8413000000000004 0.7070444561163978 0.7070431580676251 -9.660899683971297e-08 -0.09996437805907935 -2.8414 0.7070444746666142 0.7070431777730151 -9.683072165356937e-08 -0.09996438887843517 -2.8415 0.7070444932087951 0.7070431974748231 -9.70399815199488e-08 -0.09996439969450553 -2.8416000000000006 0.7070445117430761 0.7070432171729163 -9.723673194059201e-08 -0.09996441050729132 -2.8417000000000003 0.7070445302695941 0.7070432368671613 -9.742093131856477e-08 -0.09996442131679358 -2.8418 0.7070445487884862 0.7070432565574247 -9.759254096519676e-08 -0.09996443212301329 -2.8419 0.7070445672998897 0.7070432762435723 -9.775152510615309e-08 -0.0999644429259514 -2.842 0.7070445858039426 0.7070432959254702 -9.789785089271003e-08 -0.09996445372560897 -2.8421000000000003 0.7070446043007829 0.7070433156029836 -9.80314884078265e-08 -0.09996446452198698 -2.8422 0.7070446227905487 0.7070433352759775 -9.815241066614411e-08 -0.09996447531508638 -2.8423000000000003 0.7070446412733792 0.7070433549443169 -9.826059363133438e-08 -0.09996448610490823 -2.8424 0.7070446597494129 0.7070433746078664 -9.83560162056904e-08 -0.09996449689145344 -2.8425 0.7070446782187887 0.7070433942664904 -9.843866024747405e-08 -0.09996450767472305 -2.8426000000000005 0.7070446966816464 0.7070434139200537 -9.85085105648445e-08 -0.09996451845471814 -2.8427000000000002 0.7070447151381252 0.7070434335684199 -9.856555492626651e-08 -0.09996452923143961 -2.8428 0.7070447335883641 0.7070434532114533 -9.860978405877574e-08 -0.09996454000488847 -2.8429 0.7070447520325029 0.707043472849018 -9.864119164797874e-08 -0.09996455077506575 -2.843 0.7070447704706813 0.7070434924809778 -9.865977433545087e-08 -0.09996456154197238 -2.8431 0.7070447889030385 0.7070435121071966 -9.866553172654252e-08 -0.09996457230560937 -2.8432000000000004 0.707044807329714 0.7070435317275388 -9.865846638951181e-08 -0.09996458306597773 -2.8433 0.7070448257508476 0.707043551341868 -9.863858384077939e-08 -0.09996459382307848 -2.8434 0.7070448441665782 0.7070435709500484 -9.860589256140834e-08 -0.0999646045769125 -2.8435 0.7070448625770452 0.7070435905519448 -9.85604039797569e-08 -0.09996461532748091 -2.8436000000000003 0.7070448809823877 0.7070436101474213 -9.850213247581535e-08 -0.09996462607478465 -2.8437 0.7070448993827443 0.7070436297363427 -9.843109537166495e-08 -0.09996463681882471 -2.8438000000000003 0.7070449177782541 0.7070436493185739 -9.834731293147797e-08 -0.09996464755960209 -2.8439 0.7070449361690551 0.7070436688939798 -9.82508083554462e-08 -0.09996465829711779 -2.844 0.7070449545552855 0.707043688462426 -9.814160777023989e-08 -0.09996466903137279 -2.8441000000000005 0.7070449729370833 0.7070437080237783 -9.801974022380366e-08 -0.09996467976236811 -2.8442000000000003 0.7070449913145853 0.7070437275779025 -9.788523767841756e-08 -0.09996469049010463 -2.8443 0.707045009687929 0.7070437471246652 -9.773813500115608e-08 -0.09996470121458345 -2.8444000000000003 0.7070450280572512 0.7070437666639333 -9.757846995521458e-08 -0.09996471193580553 -2.8445 0.7070450464226876 0.7070437861955738 -9.74062831938377e-08 -0.09996472265377179 -2.8446000000000002 0.7070450647843745 0.707043805719455 -9.722161824210485e-08 -0.09996473336848336 -2.8447000000000005 0.7070450831424466 0.7070438252354447 -9.7024521494328e-08 -0.0999647440799411 -2.8448 0.7070451014970389 0.707043844743412 -9.681504219843928e-08 -0.09996475478814604 -2.8449 0.7070451198482854 0.7070438642432263 -9.659323244384788e-08 -0.09996476549309923 -2.845 0.7070451381963196 0.7070438837347575 -9.635914714929694e-08 -0.0999647761948016 -2.8451000000000004 0.7070451565412745 0.7070439032178759 -9.611284404725112e-08 -0.09996478689325408 -2.8452 0.707045174883282 0.7070439226924534 -9.585438367609028e-08 -0.09996479758845778 -2.8453000000000004 0.7070451932224738 0.7070439421583614 -9.558382935408866e-08 -0.09996480828041354 -2.8454 0.707045211558981 0.7070439616154727 -9.530124717681276e-08 -0.09996481896912246 -2.8455 0.7070452298929337 0.7070439810636607 -9.500670599803945e-08 -0.0999648296545855 -2.8456000000000006 0.7070452482244607 0.7070440005027996 -9.47002774002656e-08 -0.09996484033680364 -2.8457000000000003 0.7070452665536908 0.7070440199327641 -9.438203568863657e-08 -0.09996485101577779 -2.8458 0.7070452848807519 0.7070440393534306 -9.405205787446635e-08 -0.09996486169150907 -2.8459 0.7070453032057706 0.7070440587646751 -9.371042365615562e-08 -0.09996487236399838 -2.846 0.7070453215288731 0.7070440781663756 -9.335721539490555e-08 -0.09996488303324674 -2.8461000000000003 0.7070453398501844 0.7070440975584105 -9.299251809043174e-08 -0.09996489369925515 -2.8462 0.7070453581698282 0.7070441169406592 -9.261641937402532e-08 -0.09996490436202457 -2.8463000000000003 0.7070453764879279 0.7070441363130016 -9.22290094833994e-08 -0.09996491502155595 -2.8464 0.7070453948046053 0.7070441556753198 -9.183038123406623e-08 -0.09996492567785033 -2.8465 0.7070454131199817 0.7070441750274957 -9.142063000285722e-08 -0.09996493633090862 -2.8466000000000005 0.707045431434177 0.707044194369413 -9.099985370537161e-08 -0.09996494698073187 -2.8467000000000002 0.70704544974731 0.7070442137009563 -9.056815277169034e-08 -0.099964957627321 -2.8468 0.7070454680594989 0.707044233022011 -9.012563011688568e-08 -0.09996496827067702 -2.8469 0.70704548637086 0.7070442523324643 -8.967239112714354e-08 -0.09996497891080094 -2.847 0.707045504681509 0.7070442716322037 -8.9208543627671e-08 -0.09996498954769373 -2.8471 0.70704552299156 0.7070442909211185 -8.873419785927761e-08 -0.09996500018135629 -2.8472000000000004 0.7070455413011265 0.7070443101990993 -8.824946644715032e-08 -0.09996501081178975 -2.8473 0.70704555961032 0.7070443294660378 -8.775446438003681e-08 -0.09996502143899501 -2.8474 0.7070455779192515 0.7070443487218263 -8.72493089859594e-08 -0.09996503206297302 -2.8475 0.70704559622803 0.7070443679663594 -8.673411989925522e-08 -0.09996504268372486 -2.8476000000000004 0.7070456145367636 0.7070443871995322 -8.620901902848394e-08 -0.09996505330125138 -2.8477 0.7070456328455589 0.7070444064212416 -8.567413053300887e-08 -0.0999650639155536 -2.8478000000000003 0.7070456511545213 0.7070444256313861 -8.512958079784361e-08 -0.09996507452663256 -2.8479 0.7070456694637546 0.707044444829865 -8.45754983911512e-08 -0.09996508513448918 -2.848 0.7070456877733613 0.7070444640165792 -8.401201404689695e-08 -0.09996509573912443 -2.8481000000000005 0.7070457060834426 0.707044483191431 -8.343926062841928e-08 -0.09996510634053934 -2.8482000000000003 0.7070457243940982 0.7070445023543245 -8.285737309633723e-08 -0.09996511693873487 -2.8483 0.7070457427054258 0.7070445215051648 -8.226648847472345e-08 -0.09996512753371195 -2.8484000000000003 0.7070457610175227 0.7070445406438588 -8.16667458233486e-08 -0.09996513812547164 -2.8485 0.7070457793304836 0.7070445597703151 -8.105828620558891e-08 -0.09996514871401489 -2.8486000000000002 0.707045797644402 0.707044578884443 -8.044125265373181e-08 -0.0999651592993426 -2.8487000000000005 0.7070458159593702 0.7070445979861544 -7.981579013428136e-08 -0.09996516988145582 -2.8488 0.7070458342754784 0.7070446170753621 -7.918204551152913e-08 -0.09996518046035552 -2.8489 0.7070458525928159 0.7070446361519807 -7.854016752066595e-08 -0.09996519103604268 -2.849 0.7070458709114696 0.7070446552159264 -7.789030672441383e-08 -0.09996520160851828 -2.8491000000000004 0.7070458892315249 0.7070446742671171 -7.723261548180094e-08 -0.09996521217778322 -2.8492 0.707045907553066 0.7070446933054726 -7.656724791780395e-08 -0.09996522274383858 -2.8493000000000004 0.707045925876175 0.7070447123309137 -7.589435987390841e-08 -0.09996523330668527 -2.8494 0.7070459442009325 0.7070447313433632 -7.521410888122054e-08 -0.09996524386632426 -2.8495 0.7070459625274174 0.7070447503427462 -7.452665412750747e-08 -0.09996525442275656 -2.8496000000000006 0.7070459808557068 0.707044769328989 -7.383215640732396e-08 -0.09996526497598315 -2.8497000000000003 0.7070459991858761 0.7070447883020192 -7.313077809729257e-08 -0.09996527552600497 -2.8498 0.7070460175179987 0.707044807261767 -7.24226831079651e-08 -0.09996528607282301 -2.8499 0.7070460358521466 0.7070448262081638 -7.170803685259755e-08 -0.09996529661643823 -2.85 0.7070460541883898 0.7070448451411431 -7.098700620421575e-08 -0.09996530715685159 -2.8501000000000003 0.7070460725267964 0.7070448640606403 -7.025975945745139e-08 -0.0999653176940641 -2.8502 0.7070460908674325 0.7070448829665923 -6.952646629211287e-08 -0.09996532822807665 -2.8503000000000003 0.7070461092103633 0.7070449018589379 -6.878729773111825e-08 -0.09996533875889028 -2.8504 0.707046127555651 0.7070449207376182 -6.804242610146394e-08 -0.09996534928650602 -2.8505 0.7070461459033566 0.7070449396025755 -6.729202499172401e-08 -0.09996535981092472 -2.8506000000000005 0.7070461642535391 0.7070449584537541 -6.653626921431996e-08 -0.09996537033214736 -2.8507000000000002 0.7070461826062554 0.7070449772911009 -6.57753347638873e-08 -0.09996538085017503 -2.8508 0.707046200961561 0.707044996114564 -6.500939877781067e-08 -0.09996539136500864 -2.8509 0.7070462193195087 0.7070450149240936 -6.423863949285569e-08 -0.09996540187664912 -2.851 0.7070462376801503 0.7070450337196417 -6.346323620570402e-08 -0.09996541238509753 -2.8511 0.7070462560435344 0.7070450525011625 -6.268336922741688e-08 -0.0999654228903547 -2.8512000000000004 0.707046274409709 0.7070450712686117 -6.18992198461385e-08 -0.09996543339242167 -2.8513 0.7070462927787194 0.7070450900219478 -6.1110970283728e-08 -0.09996544389129947 -2.8514 0.707046311150609 0.7070451087611305 -6.031880365152398e-08 -0.09996545438698895 -2.8515 0.707046329525419 0.7070451274861214 -5.952290390871112e-08 -0.09996546487949108 -2.8516000000000004 0.7070463479031895 0.7070451461968849 -5.87234558209037e-08 -0.09996547536880696 -2.8517 0.7070463662839578 0.7070451648933866 -5.7920644916560626e-08 -0.09996548585493746 -2.8518000000000003 0.7070463846677593 0.7070451835755944 -5.7114657442750016e-08 -0.09996549633788353 -2.8519 0.7070464030546277 0.7070452022434787 -5.630568032264846e-08 -0.09996550681764624 -2.852 0.7070464214445946 0.7070452208970108 -5.549390111455818e-08 -0.09996551729422648 -2.8521000000000005 0.707046439837689 0.7070452395361648 -5.4679507963985297e-08 -0.09996552776762518 -2.8522000000000003 0.7070464582339389 0.7070452581609172 -5.38626895633075e-08 -0.09996553823784342 -2.8523 0.7070464766333693 0.7070452767712452 -5.304363510775546e-08 -0.09996554870488208 -2.8524000000000003 0.7070464950360035 0.7070452953671292 -5.222253425096052e-08 -0.0999655591687421 -2.8525 0.7070465134418633 0.7070453139485515 -5.139957706093608e-08 -0.09996556962942453 -2.8526000000000002 0.7070465318509673 0.7070453325154961 -5.0574953975625336e-08 -0.09996558008693028 -2.8527000000000005 0.7070465502633333 0.7070453510679489 -4.97488557601837e-08 -0.09996559054126028 -2.8528000000000002 0.7070465686789764 0.7070453696058983 -4.892147346296019e-08 -0.09996560099241558 -2.8529 0.7070465870979096 0.7070453881293346 -4.8092998369635674e-08 -0.0999656114403971 -2.853 0.7070466055201438 0.7070454066382502 -4.726362196050531e-08 -0.09996562188520579 -2.8531000000000004 0.7070466239456883 0.7070454251326397 -4.643353586472523e-08 -0.09996563232684265 -2.8532 0.7070466423745501 0.7070454436124994 -4.560293181721546e-08 -0.09996564276530867 -2.8533000000000004 0.7070466608067338 0.7070454620778277 -4.4772001615942403e-08 -0.09996565320060471 -2.8534 0.7070466792422423 0.7070454805286254 -4.3940937074810234e-08 -0.09996566363273185 -2.8535 0.7070466976810764 0.7070454989648949 -4.310992998006241e-08 -0.09996567406169096 -2.8536000000000006 0.7070467161232348 0.7070455173866409 -4.2279172046235975e-08 -0.09996568448748303 -2.8537000000000003 0.7070467345687141 0.7070455357938705 -4.14488548732678e-08 -0.09996569491010904 -2.8538 0.7070467530175091 0.7070455541865921 -4.061916990060572e-08 -0.09996570532956991 -2.8539 0.7070467714696118 0.7070455725648166 -3.9790308365155076e-08 -0.09996571574586662 -2.854 0.7070467899250134 0.7070455909285573 -3.8962461253058776e-08 -0.09996572615900019 -2.8541000000000003 0.7070468083837016 0.7070456092778288 -3.813581926062539e-08 -0.09996573656897145 -2.8542 0.7070468268456633 0.707045627612648 -3.731057274778977e-08 -0.09996574697578145 -2.8543000000000003 0.7070468453108827 0.7070456459330348 -3.6486911695991775e-08 -0.09996575737943121 -2.8544 0.7070468637793421 0.7070456642390093 -3.5665025659441414e-08 -0.09996576777992158 -2.8545 0.7070468822510219 0.7070456825305953 -3.484510372885226e-08 -0.09996577817725358 -2.8546000000000005 0.7070469007259002 0.7070457008078175 -3.4027334482869195e-08 -0.09996578857142813 -2.8547000000000002 0.707046919203953 0.7070457190707029 -3.321190594654348e-08 -0.09996579896244617 -2.8548 0.7070469376851548 0.7070457373192813 -3.23990055487236e-08 -0.09996580935030872 -2.8549 0.7070469561694779 0.7070457555535834 -3.158882007597667e-08 -0.0999658197350167 -2.855 0.7070469746568923 0.7070457737736424 -3.0781535634641366e-08 -0.09996583011657105 -2.8551 0.7070469931473663 0.7070457919794939 -2.9977337602689336e-08 -0.09996584049497279 -2.8552000000000004 0.707047011640866 0.7070458101711745 -2.9176410590693938e-08 -0.0999658508702228 -2.8553 0.7070470301373559 0.7070458283487236 -2.8378938398462145e-08 -0.09996586124232212 -2.8554 0.7070470486367983 0.7070458465121824 -2.758510397448538e-08 -0.09996587161127167 -2.8555 0.7070470671391538 0.7070458646615936 -2.6795089369101993e-08 -0.09996588197707242 -2.8556000000000004 0.7070470856443802 0.7070458827970023 -2.6009075698284895e-08 -0.09996589233972528 -2.8557 0.7070471041524345 0.7070459009184555 -2.522724310049032e-08 -0.09996590269923127 -2.8558000000000003 0.707047122663271 0.707045919026002 -2.4449770691988698e-08 -0.09996591305559129 -2.8559 0.707047141176842 0.7070459371196924 -2.3676836533037537e-08 -0.09996592340880628 -2.856 0.7070471596930987 0.7070459551995796 -2.2908617579309176e-08 -0.09996593375887726 -2.8561000000000005 0.7070471782119899 0.7070459732657177 -2.2145289645461586e-08 -0.09996594410580513 -2.8562000000000003 0.7070471967334622 0.7070459913181633 -2.138702736480605e-08 -0.09996595444959082 -2.8563 0.7070472152574612 0.707046009356975 -2.0634004149842206e-08 -0.09996596479023534 -2.8564000000000003 0.70704723378393 0.7070460273822126 -1.988639214888996e-08 -0.09996597512773966 -2.8565 0.7070472523128098 0.7070460453939379 -1.9144362213563415e-08 -0.09996598546210471 -2.8566000000000003 0.7070472708440406 0.7070460633922151 -1.8408083854101753e-08 -0.09996599579333143 -2.8567000000000005 0.7070472893775601 0.7070460813771096 -1.7677725199904265e-08 -0.09996600612142083 -2.8568000000000002 0.7070473079133042 0.7070460993486882 -1.6953452965703247e-08 -0.09996601644637376 -2.8569 0.7070473264512073 0.7070461173070208 -1.6235432411665363e-08 -0.09996602676819127 -2.857 0.7070473449912018 0.707046135252178 -1.552382730479404e-08 -0.0999660370868743 -2.8571000000000004 0.7070473635332184 0.7070461531842323 -1.4818799880331884e-08 -0.09996604740242371 -2.8572 0.7070473820771861 0.707046171103258 -1.412051080966828e-08 -0.09996605771484053 -2.8573000000000004 0.7070474006230323 0.7070461890093311 -1.3429119160440761e-08 -0.09996606802412568 -2.8574 0.7070474191706826 0.7070462069025298 -1.2744782359238455e-08 -0.09996607833028015 -2.8575 0.7070474377200608 0.7070462247829332 -1.2067656159076012e-08 -0.09996608863330485 -2.8576000000000006 0.7070474562710894 0.7070462426506223 -1.139789459819393e-08 -0.09996609893320074 -2.8577000000000004 0.707047474823689 0.7070462605056795 -1.0735649972302974e-08 -0.09996610922996874 -2.8578 0.707047493377779 0.7070462783481897 -1.0081072797721302e-08 -0.09996611952360984 -2.8579 0.7070475119332765 0.7070462961782383 -9.434311771042148e-09 -0.09996612981412503 -2.858 0.7070475304900974 0.7070463139959131 -8.795513744414007e-09 -0.09996614010151518 -2.8581000000000003 0.7070475490481563 0.7070463318013032 -8.16482368867777e-09 -0.0999661503857813 -2.8582 0.7070475676073655 0.707046349594499 -7.54238465346807e-09 -0.09996616066692432 -2.8583000000000003 0.7070475861676366 0.707046367375592 -6.928337751600788e-09 -0.09996617094494512 -2.8584 0.7070476047288794 0.7070463851446768 -6.3228221087660574e-09 -0.09996618121984474 -2.8585 0.7070476232910023 0.7070464029018477 -5.725974840976866e-09 -0.09996619149162407 -2.8586000000000005 0.7070476418539118 0.7070464206472014 -5.13793102681348e-09 -0.09996620176028406 -2.8587000000000002 0.707047660417514 0.7070464383808357 -4.558823670126888e-09 -0.09996621202582572 -2.8588 0.7070476789817123 0.70704645610285 -3.988783674017948e-09 -0.0999662222882499 -2.8589 0.7070476975464095 0.7070464738133451 -3.427939807010283e-09 -0.09996623254755761 -2.859 0.7070477161115072 0.7070464915124227 -2.8764186796315094e-09 -0.0999662428037498 -2.8591 0.7070477346769053 0.7070465092001865 -2.334344709718772e-09 -0.09996625305682744 -2.8592000000000004 0.7070477532425024 0.707046526876741 -1.801840101602059e-09 -0.09996626330679138 -2.8593 0.7070477718081959 0.7070465445421923 -1.2790248079402877e-09 -0.09996627355364267 -2.8594 0.7070477903738819 0.7070465621966475 -7.66016519312962e-10 -0.09996628379738219 -2.8595 0.7070478089394553 0.707046579840215 -2.629306208520865e-10 -0.0999662940380109 -2.8596000000000004 0.7070478275048098 0.7070465974730047 2.3011982423770672e-10 -0.09996630427552977 -2.8597 0.707047846069838 0.7070466150951271 7.130241041694574e-10 -0.09996631450993972 -2.8598000000000003 0.7070478646344307 0.7070466327066943 1.1856738819926438e-09 -0.09996632474124162 -2.8599 0.7070478831984786 0.7070466503078199 1.6479632138077793e-09 -0.09996633496943652 -2.86 0.7070479017618705 0.7070466678986176 2.099788586930329e-09 -0.09996634519452535 -2.8601000000000005 0.7070479203244947 0.7070466854792028 2.5410489285643267e-09 -0.099966355416509 -2.8602000000000003 0.7070479388862381 0.7070467030496923 2.9716456326905893e-09 -0.09996636563538852 -2.8603 0.7070479574469866 0.7070467206102033 3.391482588689654e-09 -0.09996637585116476 -2.8604000000000003 0.7070479760066248 0.7070467381608541 3.800466195219565e-09 -0.09996638606383866 -2.8605 0.707047994565037 0.7070467557017641 4.198505383634643e-09 -0.0999663962734112 -2.8606000000000003 0.7070480131221062 0.7070467732330539 4.585511640536888e-09 -0.09996640647988332 -2.8607000000000005 0.7070480316777142 0.7070467907548441 4.961399021653767e-09 -0.0999664166832559 -2.8608000000000002 0.7070480502317424 0.7070468082672575 5.326084172654899e-09 -0.09996642688352997 -2.8609 0.7070480687840712 0.7070468257704168 5.6794863551729025e-09 -0.09996643708070639 -2.861 0.7070480873345797 0.7070468432644458 6.0215274502728455e-09 -0.09996644727478611 -2.8611000000000004 0.7070481058831468 0.7070468607494693 6.352131994014076e-09 -0.09996645746577011 -2.8612 0.7070481244296507 0.7070468782256126 6.6712271757154995e-09 -0.09996646765365934 -2.8613000000000004 0.7070481429739681 0.707046895693002 6.97874286484379e-09 -0.09996647783845472 -2.8614 0.7070481615159756 0.7070469131517645 7.274611623156457e-09 -0.09996648802015717 -2.8615 0.707048180055549 0.7070469306020276 7.558768724651166e-09 -0.09996649819876767 -2.8616 0.7070481985925634 0.7070469480439193 7.831152159902544e-09 -0.09996650837428711 -2.8617000000000004 0.7070482171268933 0.7070469654775687 8.091702656878863e-09 -0.09996651854671648 -2.8618 0.7070482356584122 0.7070469829031052 8.340363691350383e-09 -0.09996652871605669 -2.8619 0.7070482541869937 0.7070470003206588 8.577081499899775e-09 -0.09996653888230866 -2.862 0.7070482727125104 0.7070470177303603 8.801805090330461e-09 -0.09996654904547335 -2.8621000000000003 0.7070482912348344 0.7070470351323406 9.014486253809684e-09 -0.09996655920555168 -2.8622 0.7070483097538376 0.7070470525267313 9.215079573542118e-09 -0.0999665693625446 -2.8623000000000003 0.7070483282693911 0.7070470699136645 9.403542435178214e-09 -0.09996657951645305 -2.8624 0.7070483467813662 0.7070470872932726 9.57983504242671e-09 -0.09996658966727795 -2.8625 0.7070483652896327 0.7070471046656883 9.743920407513651e-09 -0.09996659981502024 -2.8626000000000005 0.7070483837940612 0.7070471220310452 9.895764378070604e-09 -0.09996660995968087 -2.8627000000000002 0.7070484022945214 0.7070471393894766 1.0035335635399933e-08 -0.0999666201012608 -2.8628 0.7070484207908827 0.7070471567411165 1.0162605699678973e-08 -0.09996663023976093 -2.8629000000000002 0.7070484392830143 0.7070471740860989 1.0277548944705173e-08 -0.09996664037518221 -2.863 0.7070484577707852 0.7070471914245582 1.0380142587487762e-08 -0.09996665050752561 -2.8631 0.7070484762540639 0.7070472087566289 1.0470366704727618e-08 -0.09996666063679194 -2.8632000000000004 0.707048494732719 0.7070472260824456 1.0548204234551994e-08 -0.09996667076298221 -2.8633 0.7070485132066191 0.7070472434021434 1.0613640979983963e-08 -0.09996668088609739 -2.8634 0.7070485316756325 0.7070472607158573 1.0666665599401437e-08 -0.09996669100613836 -2.8635 0.7070485501396271 0.7070472780237225 1.0707269634292749e-08 -0.09996670112310607 -2.8636000000000004 0.7070485685984715 0.7070472953258737 1.0735447480633709e-08 -0.09996671123700147 -2.8637 0.7070485870520334 0.7070473126224464 1.0751196407102204e-08 -0.09996672134782543 -2.8638000000000003 0.7070486055001812 0.7070473299135758 1.0754516555078197e-08 -0.09996673145557895 -2.8639 0.7070486239427832 0.707047347199397 1.0745410928235388e-08 -0.099966741560263 -2.864 0.7070486423797075 0.7070473644800451 1.0723885396878019e-08 -0.09996675166187846 -2.8641000000000005 0.7070486608108224 0.707047381755655 1.0689948700542962e-08 -0.09996676176042622 -2.8642000000000003 0.7070486792359962 0.7070473990263614 1.0643612432387206e-08 -0.09996677185590727 -2.8643 0.7070486976550979 0.7070474162922991 1.058489104872884e-08 -0.09996678194832252 -2.8644000000000003 0.7070487160679959 0.7070474335536026 1.0513801853434535e-08 -0.09996679203767288 -2.8645 0.7070487344745596 0.707047450810406 1.0430365003991082e-08 -0.09996680212395932 -2.8646000000000003 0.7070487528746581 0.7070474680628432 1.0334603499362327e-08 -0.09996681220718273 -2.8647000000000005 0.7070487712681608 0.7070474853110482 1.0226543173050273e-08 -0.09996682228734402 -2.8648000000000002 0.707048789654938 0.7070475025551546 1.0106212691360361e-08 -0.09996683236444422 -2.8649 0.7070488080348596 0.7070475197952948 9.973643542125765e-09 -0.09996684243848417 -2.865 0.7070488264077963 0.7070475370316018 9.82887002343169e-09 -0.09996685250946478 -2.8651000000000004 0.7070488447736193 0.7070475542642082 9.671929241013288e-09 -0.09996686257738713 -2.8652 0.7070488631321998 0.7070475714932456 9.502861096979953e-09 -0.099966872642252 -2.8653000000000004 0.7070488814834096 0.7070475887188454 9.321708281141705e-09 -0.09996688270406037 -2.8654 0.7070488998271216 0.7070476059411387 9.128516258866126e-09 -0.09996689276281322 -2.8655 0.707048918163208 0.7070476231602555 8.923333255465848e-09 -0.09996690281851137 -2.8656 0.7070489364915424 0.7070476403763257 8.706210251861746e-09 -0.09996691287115576 -2.8657000000000004 0.7070489548119994 0.7070476575894789 8.477200968970422e-09 -0.09996692292074742 -2.8658 0.7070489731244529 0.7070476747998431 8.2363618520917e-09 -0.09996693296728715 -2.8659 0.7070489914287789 0.7070476920075466 7.983752055296112e-09 -0.09996694301077595 -2.866 0.707049009724853 0.707047709212717 7.719433437088086e-09 -0.09996695305121474 -2.8661000000000003 0.7070490280125519 0.7070477264154804 7.4434705335177376e-09 -0.09996696308860445 -2.8662 0.7070490462917528 0.7070477436159629 7.155930550374612e-09 -0.09996697312294595 -2.8663000000000003 0.7070490645623345 0.70704776081429 6.856883342371001e-09 -0.0999669831542403 -2.8664 0.7070490828241753 0.7070477780105855 6.546401397529433e-09 -0.0999669931824883 -2.8665 0.7070491010771551 0.7070477952049732 6.2245598250396106e-09 -0.09996700320769092 -2.8666000000000005 0.7070491193211544 0.7070478123975757 5.8914363301049155e-09 -0.09996701322984906 -2.8667000000000002 0.7070491375560548 0.707047829588515 5.5471111948604546e-09 -0.09996702324896369 -2.8668 0.7070491557817384 0.7070478467779118 5.1916672627605465e-09 -0.09996703326503564 -2.8669000000000002 0.7070491739980886 0.7070478639658861 4.825189916894679e-09 -0.09996704327806594 -2.867 0.7070491922049897 0.7070478811525573 4.4477670617729115e-09 -0.09996705328805544 -2.8671 0.7070492104023265 0.7070478983380432 4.059489098172386e-09 -0.09996706329500506 -2.8672000000000004 0.7070492285899856 0.7070479155224609 3.660448910126901e-09 -0.09996707329891581 -2.8673 0.7070492467678542 0.7070479327059267 3.250741829365078e-09 -0.09996708329978855 -2.8674 0.7070492649358202 0.7070479498885551 2.830465618830491e-09 -0.09996709329762415 -2.8675 0.7070492830937734 0.7070479670704606 2.399720457936516e-09 -0.09996710329242367 -2.8676000000000004 0.7070493012416038 0.7070479842517557 1.958608906137138e-09 -0.09996711328418795 -2.8677 0.7070493193792033 0.7070480014325522 1.5072358855797163e-09 -0.0999671232729179 -2.8678000000000003 0.7070493375064646 0.7070480186129606 1.0457086516146852e-09 -0.09996713325861448 -2.8679 0.7070493556232813 0.7070480357930902 5.741367728462343e-10 -0.09996714324127856 -2.868 0.7070493737295489 0.7070480529730491 9.263210250937126e-11 -0.09996715322091108 -2.8681000000000005 0.7070493918251635 0.7070480701529442 -3.9869125362246294e-10 -0.09996716319751298 -2.8682000000000003 0.7070494099100227 0.7070480873328813 -8.997169511151815e-10 -0.09996717317108517 -2.8683 0.7070494279840254 0.7070481045129646 -1.4103264502421387e-09 -0.09996718314162853 -2.8684000000000003 0.707049446047072 0.7070481216932976 -1.930399028994556e-09 -0.09996719310914406 -2.8685 0.7070494640990637 0.7070481388739815 -2.459811827316971e-09 -0.09996720307363266 -2.8686000000000003 0.7070494821399034 0.707048156055117 -2.998439857515578e-09 -0.09996721303509516 -2.8687000000000005 0.7070495001694954 0.7070481732368032 -3.5461560502283995e-09 -0.0999672229935326 -2.8688000000000002 0.7070495181877454 0.7070481904191376 -4.102831278711416e-09 -0.09996723294894584 -2.8689 0.7070495361945603 0.7070482076022164 -4.668334381389971e-09 -0.09996724290133582 -2.869 0.7070495541898485 0.7070482247861345 -5.242532206961581e-09 -0.0999672528507034 -2.8691000000000004 0.7070495721735202 0.7070482419709853 -5.825289630875807e-09 -0.0999672627970496 -2.8692 0.7070495901454863 0.7070482591568605 -6.416469601304431e-09 -0.09996727274037526 -2.8693 0.7070496081056598 0.7070482763438503 -7.0159331616928555e-09 -0.09996728268068122 -2.8694 0.7070496260539553 0.7070482935320441 -7.62353948632194e-09 -0.09996729261796856 -2.8695 0.7070496439902886 0.7070483107215286 -8.239145915869828e-09 -0.09996730255223811 -2.8696 0.707049661914577 0.7070483279123901 -8.862607986902249e-09 -0.09996731248349078 -2.8697000000000004 0.7070496798267398 0.7070483451047127 -9.493779466566987e-09 -0.09996732241172755 -2.8698 0.7070496977266977 0.7070483622985787 -1.0132512388155712e-08 -0.09996733233694927 -2.8699 0.7070497156143726 0.7070483794940692 -1.0778657087533172e-08 -0.09996734225915684 -2.87 0.7070497334896887 0.7070483966912637 -1.1432062232193813e-08 -0.09996735217835125 -2.8701000000000003 0.7070497513525715 0.70704841389024 -1.2092574865497224e-08 -0.09996736209453339 -2.8702 0.707049769202948 0.7070484310910738 -1.2760040429219549e-08 -0.09996737200770416 -2.8703000000000003 0.7070497870407473 0.7070484482938397 -1.343430281342678e-08 -0.0999673819178645 -2.8704 0.7070498048659 0.7070484654986102 -1.4115204386398739e-08 -0.09996739182501525 -2.8705 0.7070498226783379 0.7070484827054563 -1.4802586032792997e-08 -0.09996740172915736 -2.8706000000000005 0.7070498404779955 0.7070484999144474 -1.5496287190507746e-08 -0.09996741163029181 -2.8707000000000003 0.7070498582648082 0.7070485171256509 -1.6196145887978353e-08 -0.09996742152841943 -2.8708 0.7070498760387136 0.7070485343391324 -1.6901998781040234e-08 -0.09996743142354116 -2.8709000000000002 0.7070498937996512 0.7070485515549559 -1.761368119412854e-08 -0.09996744131565788 -2.871 0.7070499115475619 0.7070485687731837 -1.8331027151936852e-08 -0.09996745120477057 -2.8711 0.7070499292823883 0.7070485859938761 -1.9053869430157855e-08 -0.09996746109088009 -2.8712000000000004 0.7070499470040754 0.7070486032170915 -1.978203958150418e-08 -0.09996747097398738 -2.8713 0.7070499647125699 0.7070486204428872 -2.0515367983413302e-08 -0.09996748085409339 -2.8714 0.7070499824078197 0.7070486376713176 -2.1253683872742013e-08 -0.09996749073119898 -2.8715 0.707050000089775 0.7070486549024357 -2.1996815388267144e-08 -0.09996750060530504 -2.8716000000000004 0.7070500177583879 0.7070486721362931 -2.274458960884948e-08 -0.09996751047641252 -2.8717 0.7070500354136122 0.7070486893729386 -2.349683259506713e-08 -0.09996752034452229 -2.8718000000000004 0.707050053055404 0.7070487066124199 -2.4253369431716243e-08 -0.09996753020963527 -2.8719 0.7070500706837207 0.7070487238547827 -2.5014024261204443e-08 -0.09996754007175242 -2.872 0.7070500882985218 0.7070487411000702 -2.5778620333424124e-08 -0.09996754993087457 -2.8721000000000005 0.7070501058997689 0.7070487583483245 -2.6546980041314283e-08 -0.09996755978700267 -2.8722000000000003 0.7070501234874255 0.7070487755995858 -2.7318924961626523e-08 -0.0999675696401377 -2.8723 0.7070501410614567 0.7070487928538912 -2.809427590046154e-08 -0.09996757949028046 -2.8724000000000003 0.70705015862183 0.7070488101112771 -2.8872852930348844e-08 -0.09996758933743187 -2.8725 0.7070501761685145 0.7070488273717774 -2.9654475437084285e-08 -0.09996759918159293 -2.8726000000000003 0.7070501937014815 0.7070488446354243 -3.043896215550873e-08 -0.09996760902276451 -2.8727000000000005 0.7070502112207038 0.7070488619022477 -3.122613121677928e-08 -0.09996761886094746 -2.8728000000000002 0.7070502287261564 0.707048879172276 -3.2015800186316334e-08 -0.09996762869614273 -2.8729 0.7070502462178165 0.7070488964455351 -3.280778610890642e-08 -0.0999676385283512 -2.873 0.707050263695663 0.7070489137220493 -3.360190555098605e-08 -0.09996764835757374 -2.8731000000000004 0.7070502811596773 0.7070489310018409 -3.439797464184144e-08 -0.09996765818381136 -2.8732 0.7070502986098419 0.7070489482849301 -3.51958091161092e-08 -0.09996766800706493 -2.8733 0.7070503160461419 0.7070489655713352 -3.599522435887917e-08 -0.09996767782733533 -2.8734 0.707050333468564 0.7070489828610727 -3.679603544526778e-08 -0.09996768764462348 -2.8735 0.7070503508770976 0.7070490001541563 -3.759805718411141e-08 -0.09996769745893028 -2.8736 0.7070503682717328 0.7070490174505988 -3.840110416209342e-08 -0.09996770727025661 -2.8737000000000004 0.7070503856524633 0.7070490347504106 -3.920499078505224e-08 -0.09996771707860347 -2.8738 0.7070504030192837 0.7070490520535998 -4.000953132097e-08 -0.09996772688397168 -2.8739 0.7070504203721906 0.7070490693601726 -4.081453994458743e-08 -0.09996773668636214 -2.874 0.7070504377111833 0.7070490866701336 -4.161983077768201e-08 -0.09996774648577578 -2.8741000000000003 0.7070504550362626 0.707049103983485 -4.242521793414362e-08 -0.09996775628221356 -2.8742 0.7070504723474311 0.7070491213002268 -4.3230515560510195e-08 -0.09996776607567627 -2.8743000000000003 0.707050489644694 0.7070491386203575 -4.403553788378102e-08 -0.09996777586616486 -2.8744 0.707050506928058 0.7070491559438736 -4.4840099247398695e-08 -0.09996778565368025 -2.8745 0.7070505241975319 0.7070491732707694 -4.5644014159875596e-08 -0.09996779543822332 -2.8746000000000005 0.7070505414531267 0.7070491906010372 -4.644709733318819e-08 -0.099967805219795 -2.8747000000000003 0.707050558694855 0.7070492079346674 -4.7249163728747216e-08 -0.09996781499839619 -2.8748 0.7070505759227319 0.7070492252716483 -4.8050028598231424e-08 -0.09996782477402776 -2.8749000000000002 0.7070505931367737 0.7070492426119661 -4.8849507527470686e-08 -0.09996783454669056 -2.875 0.707050610337 0.7070492599556059 -4.9647416475477255e-08 -0.09996784431638567 -2.8751 0.7070506275234312 0.7070492773025496 -5.044357182307224e-08 -0.0999678540831139 -2.8752000000000004 0.7070506446960894 0.7070492946527778 -5.123779040763429e-08 -0.09996786384687609 -2.8753 0.7070506618550001 0.7070493120062689 -5.2029889571671845e-08 -0.09996787360767322 -2.8754 0.7070506790001895 0.7070493293629996 -5.2819687202179666e-08 -0.0999678833655061 -2.8755 0.7070506961316861 0.7070493467229444 -5.36070017716217e-08 -0.09996789312037573 -2.8756000000000004 0.7070507132495207 0.707049364086076 -5.439165237848022e-08 -0.09996790287228292 -2.8757 0.7070507303537257 0.7070493814523651 -5.517345879452705e-08 -0.09996791262122866 -2.8758000000000004 0.7070507474443352 0.7070493988217805 -5.595224150016856e-08 -0.09996792236721373 -2.8759 0.7070507645213857 0.7070494161942892 -5.672782172824742e-08 -0.09996793211023913 -2.876 0.7070507815849152 0.7070494335698561 -5.750002150502545e-08 -0.09996794185030572 -2.8761000000000005 0.7070507986349641 0.7070494509484441 -5.8268663689431746e-08 -0.09996795158741438 -2.8762000000000003 0.7070508156715741 0.7070494683300145 -5.903357201643075e-08 -0.09996796132156599 -2.8763 0.7070508326947896 0.7070494857145269 -5.979457113605355e-08 -0.0999679710527616 -2.8764000000000003 0.707050849704656 0.7070495031019386 -6.055148665373017e-08 -0.099967980781002 -2.8765 0.7070508667012207 0.7070495204922049 -6.130414516867036e-08 -0.09996799050628805 -2.8766000000000003 0.7070508836845337 0.7070495378852798 -6.205237431571378e-08 -0.09996800022862073 -2.8767000000000005 0.7070509006546457 0.7070495552811151 -6.279600280392761e-08 -0.09996800994800087 -2.8768000000000002 0.7070509176116101 0.7070495726796605 -6.353486045607148e-08 -0.09996801966442934 -2.8769 0.7070509345554821 0.7070495900808647 -6.426877824676144e-08 -0.09996802937790714 -2.877 0.7070509514863181 0.7070496074846739 -6.499758834150118e-08 -0.09996803908843511 -2.8771000000000004 0.7070509684041766 0.7070496248910326 -6.572112413614703e-08 -0.09996804879601412 -2.8772 0.707050985309118 0.707049642299884 -6.643922029246976e-08 -0.09996805850064505 -2.8773 0.7070510022012044 0.7070496597111688 -6.715171278022167e-08 -0.09996806820232887 -2.8774 0.7070510190804994 0.7070496771248269 -6.785843891009627e-08 -0.09996807790106642 -2.8775 0.7070510359470688 0.7070496945407956 -6.85592373710249e-08 -0.09996808759685863 -2.8776 0.7070510528009799 0.7070497119590109 -6.925394827050901e-08 -0.0999680972897064 -2.8777000000000004 0.7070510696423016 0.7070497293794069 -6.994241316801361e-08 -0.09996810697961062 -2.8778 0.7070510864711042 0.7070497468019165 -7.062447511529957e-08 -0.09996811666657215 -2.8779 0.7070511032874602 0.7070497642264701 -7.129997868678128e-08 -0.09996812635059192 -2.878 0.7070511200914437 0.707049781652997 -7.196877001465485e-08 -0.09996813603167078 -2.8781000000000003 0.7070511368831298 0.707049799081425 -7.263069683183243e-08 -0.09996814570980961 -2.8782 0.7070511536625962 0.7070498165116799 -7.328560849752946e-08 -0.09996815538500936 -2.8783000000000003 0.7070511704299214 0.7070498339436861 -7.393335603412751e-08 -0.0999681650572709 -2.8784 0.7070511871851858 0.7070498513773664 -7.457379216533819e-08 -0.09996817472659508 -2.8785 0.7070512039284718 0.7070498688126421 -7.520677134612713e-08 -0.09996818439298291 -2.8786000000000005 0.7070512206598621 0.7070498862494325 -7.583214979524008e-08 -0.09996819405643517 -2.8787000000000003 0.7070512373794422 0.7070499036876563 -7.644978552816262e-08 -0.09996820371695275 -2.8788 0.7070512540872985 0.70704992112723 -7.70595383900799e-08 -0.09996821337453665 -2.8789000000000002 0.7070512707835189 0.7070499385680686 -7.76612700892701e-08 -0.09996822302918766 -2.879 0.7070512874681929 0.707049956010086 -7.825484422616102e-08 -0.09996823268090671 -2.8791 0.7070513041414115 0.7070499734531945 -7.884012632412146e-08 -0.09996824232969469 -2.8792000000000004 0.7070513208032667 0.7070499908973047 -7.941698385895146e-08 -0.09996825197555248 -2.8793 0.7070513374538524 0.707050008342326 -7.99852862918421e-08 -0.09996826161848094 -2.8794 0.7070513540932635 0.7070500257881667 -8.054490509799839e-08 -0.09996827125848096 -2.8795 0.7070513707215966 0.7070500432347336 -8.109571379526226e-08 -0.09996828089555351 -2.8796000000000004 0.7070513873389496 0.7070500606819317 -8.163758797013337e-08 -0.09996829052969941 -2.8797 0.7070514039454211 0.7070500781296654 -8.217040531159625e-08 -0.09996830016091954 -2.8798000000000004 0.7070514205411118 0.7070500955778375 -8.269404563453903e-08 -0.09996830978921484 -2.8799 0.7070514371261236 0.7070501130263492 -8.320839090490695e-08 -0.09996831941458617 -2.88 0.7070514537005586 0.7070501304751009 -8.37133252752642e-08 -0.09996832903703433 -2.8801000000000005 0.7070514702645214 0.7070501479239921 -8.420873509693699e-08 -0.09996833865656038 -2.8802000000000003 0.7070514868181174 0.7070501653729202 -8.46945089564427e-08 -0.09996834827316513 -2.8803 0.7070515033614527 0.707050182821782 -8.517053770064342e-08 -0.09996835788684943 -2.8804000000000003 0.707051519894635 0.7070502002704733 -8.563671445496052e-08 -0.09996836749761424 -2.8805 0.7070515364177729 0.7070502177188882 -8.609293465113022e-08 -0.0999683771054604 -2.8806000000000003 0.7070515529309762 0.7070502351669201 -8.653909604888765e-08 -0.09996838671038877 -2.8807000000000005 0.7070515694343563 0.7070502526144613 -8.6975098760253e-08 -0.09996839631240031 -2.8808000000000002 0.7070515859280244 0.707050270061403 -8.74008452712155e-08 -0.0999684059114958 -2.8809 0.7070516024120936 0.7070502875076354 -8.78162404660196e-08 -0.09996841550767621 -2.881 0.707051618886678 0.7070503049530479 -8.822119164277747e-08 -0.09996842510094239 -2.8811000000000004 0.7070516353518923 0.7070503223975284 -8.861560854035722e-08 -0.09996843469129524 -2.8812 0.7070516518078525 0.7070503398409644 -8.899940335139328e-08 -0.0999684442787356 -2.8813 0.7070516682546749 0.7070503572832423 -8.937249074743997e-08 -0.09996845386326438 -2.8814 0.7070516846924779 0.7070503747242478 -8.973478789892075e-08 -0.09996846344488255 -2.8815 0.7070517011213794 0.7070503921638654 -9.008621449160814e-08 -0.09996847302359092 -2.8816 0.7070517175414988 0.707050409601979 -9.042669273789938e-08 -0.09996848259939038 -2.8817000000000004 0.7070517339529561 0.7070504270384714 -9.07561474080415e-08 -0.09996849217228178 -2.8818 0.7070517503558722 0.7070504444732248 -9.107450583360072e-08 -0.099968501742266 -2.8819 0.7070517667503688 0.7070504619061209 -9.13816979274118e-08 -0.09996851130934395 -2.882 0.7070517831365686 0.7070504793370405 -9.167765619919055e-08 -0.09996852087351654 -2.8821000000000003 0.7070517995145944 0.7070504967658635 -9.196231578068731e-08 -0.09996853043478467 -2.8822 0.7070518158845697 0.7070505141924693 -9.223561441701333e-08 -0.09996853999314913 -2.8823000000000003 0.707051832246619 0.7070505316167368 -9.249749250133527e-08 -0.09996854954861085 -2.8824 0.7070518486008672 0.7070505490385443 -9.274789307921194e-08 -0.09996855910117072 -2.8825 0.7070518649474399 0.7070505664577691 -9.298676185813537e-08 -0.09996856865082959 -2.8826000000000005 0.707051881286463 0.7070505838742882 -9.321404722748006e-08 -0.09996857819758836 -2.8827000000000003 0.7070518976180638 0.7070506012879783 -9.342970026023772e-08 -0.09996858774144796 -2.8828 0.7070519139423685 0.7070506186987155 -9.363367472862982e-08 -0.09996859728240923 -2.8829000000000002 0.707051930259505 0.7070506361063751 -9.382592711711796e-08 -0.09996860682047298 -2.883 0.7070519465696015 0.7070506535108325 -9.400641662934278e-08 -0.09996861635564024 -2.8831 0.7070519628727859 0.7070506709119623 -9.417510518985872e-08 -0.09996862588791176 -2.8832000000000004 0.7070519791691872 0.7070506883096386 -9.433195745801176e-08 -0.0999686354172884 -2.8833 0.7070519954589347 0.7070507057037358 -9.447694084008251e-08 -0.09996864494377118 -2.8834 0.7070520117421575 0.7070507230941276 -9.46100254849494e-08 -0.09996865446736088 -2.8835 0.7070520280189855 0.7070507404806872 -9.473118429796645e-08 -0.09996866398805837 -2.8836000000000004 0.7070520442895487 0.7070507578632874 -9.484039294530011e-08 -0.09996867350586458 -2.8837 0.7070520605539774 0.7070507752418016 -9.493762985653131e-08 -0.09996868302078034 -2.8838000000000004 0.7070520768124016 0.7070507926161023 -9.502287623072703e-08 -0.09996869253280655 -2.8839 0.7070520930649522 0.707050809986062 -9.509611603904233e-08 -0.09996870204194407 -2.884 0.7070521093117599 0.7070508273515534 -9.515733602385307e-08 -0.09996871154819384 -2.8841000000000006 0.7070521255529554 0.7070508447124485 -9.520652571089888e-08 -0.09996872105155667 -2.8842000000000003 0.7070521417886694 0.7070508620686198 -9.524367740234435e-08 -0.09996873055203348 -2.8843 0.7070521580190331 0.7070508794199395 -9.526878618111578e-08 -0.09996874004962515 -2.8844000000000003 0.7070521742441772 0.7070508967662794 -9.528184991090122e-08 -0.09996874954433249 -2.8845 0.7070521904642326 0.7070509141075119 -9.528286923094625e-08 -0.09996875903615639 -2.8846000000000003 0.7070522066793308 0.707050931443509 -9.527184756559504e-08 -0.09996876852509781 -2.8847000000000005 0.7070522228896017 0.7070509487741432 -9.524879110867773e-08 -0.09996877801115751 -2.8848000000000003 0.7070522390951766 0.7070509660992867 -9.521370883478625e-08 -0.09996878749433641 -2.8849 0.7070522552961862 0.7070509834188121 -9.516661248626379e-08 -0.09996879697463544 -2.885 0.7070522714927606 0.7070510007325922 -9.510751658014377e-08 -0.09996880645205544 -2.8851000000000004 0.70705228768503 0.7070510180404996 -9.503643839253728e-08 -0.09996881592659723 -2.8852 0.7070523038731245 0.7070510353424074 -9.495339796036784e-08 -0.0999688253982617 -2.8853 0.7070523200571741 0.7070510526381892 -9.485841807009565e-08 -0.09996883486704981 -2.8854 0.7070523362373082 0.7070510699277184 -9.475152425945238e-08 -0.09996884433296238 -2.8855 0.7070523524136557 0.7070510872108688 -9.463274481223694e-08 -0.09996885379600025 -2.8856 0.7070523685863459 0.7070511044875151 -9.450211074270298e-08 -0.09996886325616437 -2.8857000000000004 0.707052384755507 0.7070511217575314 -9.435965578775268e-08 -0.09996887271345556 -2.8858 0.7070524009212669 0.7070511390207929 -9.420541640173252e-08 -0.09996888216787468 -2.8859 0.7070524170837535 0.7070511562771751 -9.403943175122914e-08 -0.09996889161942261 -2.886 0.7070524332430939 0.7070511735265537 -9.386174369945682e-08 -0.09996890106810025 -2.8861000000000003 0.7070524493994146 0.7070511907688052 -9.367239679584916e-08 -0.0999689105139084 -2.8862 0.7070524655528423 0.7070512080038065 -9.34714382630486e-08 -0.09996891995684802 -2.8863000000000003 0.7070524817035021 0.7070512252314349 -9.32589179969065e-08 -0.0999689293969199 -2.8864 0.7070524978515194 0.7070512424515686 -9.303488853872749e-08 -0.09996893883412494 -2.8865 0.7070525139970187 0.7070512596640859 -9.279940507266743e-08 -0.09996894826846403 -2.8866000000000005 0.7070525301401238 0.7070512768688664 -9.255252540404935e-08 -0.09996895769993804 -2.8867000000000003 0.707052546280958 0.7070512940657898 -9.229430995676136e-08 -0.0999689671285479 -2.8868 0.7070525624196438 0.7070513112547365 -9.202482174550108e-08 -0.09996897655429436 -2.8869000000000002 0.707052578556303 0.707051328435588 -9.174412637664303e-08 -0.09996898597717839 -2.887 0.7070525946910566 0.7070513456082261 -9.145229200833993e-08 -0.09996899539720078 -2.8871 0.707052610824025 0.7070513627725337 -9.114938936266581e-08 -0.09996900481436244 -2.8872000000000004 0.7070526269553277 0.7070513799283942 -9.083549168224792e-08 -0.09996901422866421 -2.8873 0.7070526430850833 0.7070513970756922 -9.051067473113406e-08 -0.09996902364010701 -2.8874 0.7070526592134097 0.7070514142143125 -9.01750167679044e-08 -0.09996903304869162 -2.8875 0.7070526753404239 0.7070514313441416 -8.982859852832425e-08 -0.099969042454419 -2.8876000000000004 0.7070526914662422 0.7070514484650661 -8.947150320626207e-08 -0.09996905185728994 -2.8877 0.7070527075909794 0.7070514655769741 -8.91038164328728e-08 -0.09996906125730537 -2.8878000000000004 0.7070527237147497 0.7070514826797545 -8.87256262575159e-08 -0.09996907065446607 -2.8879 0.7070527398376669 0.7070514997732973 -8.833702312867342e-08 -0.09996908004877308 -2.888 0.707052755959843 0.7070515168574929 -8.793809986619439e-08 -0.09996908944022712 -2.8881000000000006 0.7070527720813888 0.7070515339322335 -8.752895164828439e-08 -0.0999690988288291 -2.8882000000000003 0.7070527882024151 0.707051550997412 -8.710967597681113e-08 -0.09996910821457988 -2.8883 0.7070528043230304 0.7070515680529221 -8.668037266949813e-08 -0.09996911759748034 -2.8884000000000003 0.7070528204433428 0.7070515850986587 -8.624114381655668e-08 -0.09996912697753127 -2.8885 0.7070528365634594 0.7070516021345187 -8.579209377548164e-08 -0.09996913635473362 -2.8886000000000003 0.7070528526834858 0.7070516191603989 -8.533332913375491e-08 -0.09996914572908824 -2.8887000000000005 0.7070528688035265 0.7070516361761979 -8.486495869063082e-08 -0.09996915510059595 -2.8888000000000003 0.7070528849236848 0.7070516531818156 -8.438709342938056e-08 -0.09996916446925767 -2.8889 0.7070529010440629 0.707051670177153 -8.389984648259768e-08 -0.09996917383507425 -2.889 0.7070529171647615 0.707051687162112 -8.340333312265719e-08 -0.09996918319804651 -2.8891000000000004 0.7070529332858805 0.707051704136596 -8.289767072094945e-08 -0.09996919255817534 -2.8892 0.7070529494075182 0.7070517211005101 -8.238297872359412e-08 -0.09996920191546166 -2.8893 0.7070529655297716 0.7070517380537601 -8.185937862368459e-08 -0.09996921126990632 -2.8894 0.7070529816527362 0.7070517549962534 -8.132699393700177e-08 -0.0999692206215101 -2.8895 0.7070529977765065 0.707051771927899 -8.078595016558499e-08 -0.09996922997027402 -2.8896 0.7070530139011753 0.7070517888486064 -8.023637477084372e-08 -0.09996923931619872 -2.8897000000000004 0.7070530300268341 0.7070518057582875 -7.96783971423326e-08 -0.0999692486592852 -2.8898 0.7070530461535733 0.7070518226568552 -7.911214857173055e-08 -0.0999692579995343 -2.8899 0.7070530622814816 0.7070518395442235 -7.853776222074837e-08 -0.09996926733694687 -2.89 0.7070530784106459 0.7070518564203084 -7.795537308383227e-08 -0.09996927667152378 -2.8901000000000003 0.7070530945411522 0.7070518732850272 -7.736511796301027e-08 -0.09996928600326582 -2.8902 0.707053110673085 0.7070518901382986 -7.67671354375346e-08 -0.099969295332174 -2.8903000000000003 0.7070531268065268 0.7070519069800429 -7.616156582051364e-08 -0.09996930465824905 -2.8904 0.707053142941559 0.7070519238101817 -7.554855113549308e-08 -0.09996931398149186 -2.8905 0.7070531590782616 0.7070519406286386 -7.492823508132782e-08 -0.0999693233019034 -2.8906000000000005 0.7070531752167124 0.7070519574353387 -7.430076299835484e-08 -0.09996933261948444 -2.8907000000000003 0.7070531913569879 0.7070519742302078 -7.366628183369875e-08 -0.0999693419342358 -2.8908 0.7070532074991631 0.7070519910131745 -7.30249401091794e-08 -0.09996935124615841 -2.8909000000000002 0.7070532236433117 0.7070520077841682 -7.237688788097954e-08 -0.0999693605552531 -2.891 0.707053239789505 0.7070520245431202 -7.172227670841982e-08 -0.09996936986152066 -2.8911000000000002 0.7070532559378131 0.7070520412899635 -7.106125962013168e-08 -0.09996937916496203 -2.8912000000000004 0.7070532720883049 0.7070520580246329 -7.039399107589342e-08 -0.09996938846557811 -2.8913 0.7070532882410465 0.7070520747470648 -6.972062692933365e-08 -0.09996939776336965 -2.8914 0.7070533043961031 0.7070520914571966 -6.904132439410418e-08 -0.09996940705833754 -2.8915 0.7070533205535385 0.7070521081549687 -6.835624200614981e-08 -0.09996941635048273 -2.8916000000000004 0.7070533367134136 0.7070521248403221 -6.766553958771279e-08 -0.09996942563980592 -2.8917 0.7070533528757889 0.7070521415132 -6.69693782091689e-08 -0.09996943492630805 -2.8918000000000004 0.7070533690407221 0.7070521581735474 -6.626792014869515e-08 -0.09996944420999002 -2.8919 0.7070533852082701 0.7070521748213111 -6.556132886277946e-08 -0.09996945349085269 -2.892 0.707053401378487 0.7070521914564392 -6.484976893764843e-08 -0.09996946276889682 -2.8921000000000006 0.7070534175514259 0.7070522080788819 -6.413340605717494e-08 -0.09996947204412332 -2.8922000000000003 0.7070534337271378 0.7070522246885913 -6.34124069668826e-08 -0.09996948131653305 -2.8923 0.7070534499056719 0.7070522412855211 -6.268693942493991e-08 -0.09996949058612684 -2.8924000000000003 0.7070534660870755 0.707052257869627 -6.19571721739709e-08 -0.09996949985290554 -2.8925 0.7070534822713943 0.7070522744408667 -6.122327489812077e-08 -0.09996950911687007 -2.8926000000000003 0.707053498458672 0.707052290999199 -6.04854181796878e-08 -0.0999695183780212 -2.8927000000000005 0.7070535146489505 0.7070523075445849 -5.974377346442891e-08 -0.09996952763635979 -2.8928000000000003 0.70705353084227 0.707052324076988 -5.899851302014307e-08 -0.09996953689188676 -2.8929 0.7070535470386685 0.7070523405963728 -5.824980989742323e-08 -0.0999695461446029 -2.893 0.7070535632381825 0.7070523571027059 -5.7497837886721914e-08 -0.09996955539450914 -2.8931000000000004 0.7070535794408463 0.7070523735959559 -5.674277148127148e-08 -0.09996956464160626 -2.8932 0.7070535956466928 0.7070523900760934 -5.598478583501709e-08 -0.09996957388589517 -2.8933 0.7070536118557523 0.7070524065430905 -5.5224056721633885e-08 -0.09996958312737668 -2.8934 0.7070536280680537 0.7070524229969215 -5.446076049484515e-08 -0.09996959236605163 -2.8935 0.7070536442836242 0.7070524394375626 -5.3695074049391056e-08 -0.09996960160192092 -2.8936 0.7070536605024884 0.7070524558649919 -5.2927174773974295e-08 -0.09996961083498539 -2.8937000000000004 0.7070536767246693 0.7070524722791891 -5.215724051699927e-08 -0.09996962006524585 -2.8938 0.7070536929501883 0.7070524886801364 -5.138544954081878e-08 -0.0999696292927032 -2.8939 0.7070537091790645 0.7070525050678174 -5.0611980481618524e-08 -0.09996963851735828 -2.894 0.7070537254113154 0.7070525214422174 -4.983701231060268e-08 -0.09996964773921191 -2.8941000000000003 0.707053741646956 0.7070525378033247 -4.906072428921635e-08 -0.09996965695826494 -2.8942 0.7070537578859999 0.7070525541511286 -4.828329592913849e-08 -0.09996966617451825 -2.8943000000000003 0.7070537741284589 0.7070525704856205 -4.750490695119066e-08 -0.09996967538797273 -2.8944 0.7070537903743421 0.7070525868067938 -4.67257372423484e-08 -0.09996968459862911 -2.8945 0.7070538066236578 0.7070526031146444 -4.594596681665574e-08 -0.0999696938064884 -2.8946000000000005 0.7070538228764112 0.7070526194091689 -4.516577576936347e-08 -0.09996970301155132 -2.8947000000000003 0.7070538391326062 0.7070526356903666 -4.438534424188226e-08 -0.09996971221381878 -2.8948 0.7070538553922447 0.707052651958239 -4.3604852373752565e-08 -0.09996972141329163 -2.8949000000000003 0.7070538716553267 0.7070526682127891 -4.282448026429091e-08 -0.09996973060997066 -2.895 0.7070538879218498 0.7070526844540216 -4.2044407930116314e-08 -0.09996973980385676 -2.8951000000000002 0.7070539041918102 0.7070527006819436 -4.1264815265793734e-08 -0.09996974899495076 -2.8952000000000004 0.7070539204652025 0.7070527168965642 -4.0485881998189154e-08 -0.09996975818325354 -2.8953 0.7070539367420182 0.7070527330978941 -3.97077876500675e-08 -0.09996976736876592 -2.8954 0.7070539530222479 0.707052749285946 -3.8930711494637466e-08 -0.09996977655148874 -2.8955 0.7070539693058798 0.7070527654607346 -3.815483251546313e-08 -0.09996978573142289 -2.8956000000000004 0.7070539855929003 0.7070527816222765 -3.738032936602322e-08 -0.09996979490856914 -2.8957 0.7070540018832943 0.7070527977705898 -3.660738032769829e-08 -0.0999698040829284 -2.8958000000000004 0.7070540181770438 0.7070528139056956 -3.5836163271660976e-08 -0.09996981325450152 -2.8959 0.7070540344741298 0.7070528300276159 -3.5066855612526406e-08 -0.09996982242328933 -2.896 0.7070540507745313 0.7070528461363748 -3.4299634271706125e-08 -0.09996983158929267 -2.8961000000000006 0.7070540670782246 0.7070528622319985 -3.353467563534107e-08 -0.09996984075251236 -2.8962000000000003 0.7070540833851853 0.707052878314515 -3.2772155513210305e-08 -0.09996984991294935 -2.8963 0.707054099695386 0.7070528943839542 -3.2012249100024995e-08 -0.09996985907060436 -2.8964000000000003 0.7070541160087982 0.7070529104403476 -3.1255130934337155e-08 -0.09996986822547826 -2.8965 0.7070541323253916 0.7070529264837291 -3.0500974858641006e-08 -0.09996987737757199 -2.8966000000000003 0.7070541486451333 0.7070529425141341 -2.9749953978173288e-08 -0.09996988652688626 -2.8967 0.7070541649679889 0.7070529585315997 -2.9002240624050393e-08 -0.09996989567342197 -2.8968000000000003 0.7070541812939223 0.7070529745361654 -2.8258006310333955e-08 -0.09996990481717999 -2.8969 0.7070541976228957 0.707052990527872 -2.7517421696083774e-08 -0.09996991395816113 -2.897 0.7070542139548692 0.7070530065067621 -2.67806565471939e-08 -0.09996992309636625 -2.8971000000000005 0.707054230289801 0.7070530224728806 -2.6047879696927678e-08 -0.09996993223179618 -2.8972 0.7070542466276478 0.7070530384262741 -2.5319259007536982e-08 -0.0999699413644518 -2.8973 0.7070542629683645 0.7070530543669906 -2.4594961331014104e-08 -0.09996995049433392 -2.8974 0.7070542793119039 0.7070530702950799 -2.3875152470494154e-08 -0.09996995962144337 -2.8975 0.7070542956582173 0.7070530862105939 -2.3159997144910072e-08 -0.09996996874578103 -2.8976 0.7070543120072541 0.7070531021135862 -2.2449658945624534e-08 -0.09996997786734771 -2.8977000000000004 0.7070543283589621 0.707053118004112 -2.1744300306939662e-08 -0.09996998698614426 -2.8978 0.7070543447132869 0.7070531338822281 -2.1044082463596292e-08 -0.0999699961021715 -2.8979 0.7070543610701732 0.7070531497479935 -2.0349165414778464e-08 -0.09997000521543027 -2.898 0.7070543774295635 0.7070531656014685 -1.9659707889418954e-08 -0.09997001432592144 -2.8981000000000003 0.7070543937913987 0.7070531814427148 -1.8975867307601674e-08 -0.09997002343364586 -2.8982 0.7070544101556181 0.707053197271797 -1.82977997436988e-08 -0.09997003253860437 -2.8983000000000003 0.707054426522159 0.7070532130887799 -1.7625659896880475e-08 -0.09997004164079776 -2.8984 0.7070544428909573 0.7070532288937306 -1.6959601049481438e-08 -0.09997005074022691 -2.8985 0.7070544592619474 0.707053244686718 -1.6299775034908648e-08 -0.09997005983689265 -2.8986000000000005 0.7070544756350621 0.7070532604678126 -1.5646332201212088e-08 -0.09997006893079587 -2.8987000000000003 0.7070544920102322 0.7070532762370859 -1.4999421378125016e-08 -0.09997007802193732 -2.8988 0.7070545083873871 0.7070532919946115 -1.4359189844971587e-08 -0.09997008711031788 -2.8989000000000003 0.7070545247664551 0.7070533077404646 -1.3725783292069249e-08 -0.0999700961959384 -2.899 0.7070545411473623 0.7070533234747216 -1.309934579253949e-08 -0.09997010527879968 -2.8991000000000002 0.7070545575300334 0.7070533391974605 -1.2480019770649137e-08 -0.09997011435890256 -2.8992000000000004 0.7070545739143923 0.7070533549087612 -1.1867945961911708e-08 -0.09997012343624795 -2.8993 0.7070545903003602 0.7070533706087048 -1.1263263386199207e-08 -0.0999701325108366 -2.8994 0.7070546066878578 0.7070533862973736 -1.0666109321287587e-08 -0.09997014158266936 -2.8995 0.7070546230768039 0.7070534019748519 -1.0076619261223385e-08 -0.09997015065174708 -2.8996000000000004 0.7070546394671162 0.7070534176412252 -9.494926889869193e-09 -0.09997015971807063 -2.8997 0.7070546558587105 0.7070534332965801 -8.921164056617525e-09 -0.0999701687816408 -2.8998000000000004 0.7070546722515016 0.7070534489410053 -8.355460733890097e-09 -0.09997017784245846 -2.8999 0.7070546886454032 0.7070534645745903 -7.797945001525308e-09 -0.09997018690052448 -2.9 0.7070547050403266 0.707053480197426 -7.248743013818504e-09 -0.09997019595583964 -2.9001000000000006 0.7070547214361829 0.7070534958096046 -6.707978957888605e-09 -0.09997020500840476 -2.9002000000000003 0.7070547378328809 0.7070535114112202 -6.175775043269771e-09 -0.09997021405822071 -2.9003 0.7070547542303293 0.7070535270023672 -5.652251467216929e-09 -0.09997022310528832 -2.9004000000000003 0.7070547706284341 0.707053542583142 -5.137526388684921e-09 -0.09997023214960837 -2.9005 0.7070547870271013 0.7070535581536421 -4.63171589536876e-09 -0.09997024119118175 -2.9006000000000003 0.7070548034262353 0.7070535737139663 -4.134933988091116e-09 -0.09997025023000933 -2.9007 0.7070548198257389 0.7070535892642141 -3.64729254610785e-09 -0.0999702592660919 -2.9008000000000003 0.7070548362255141 0.7070536048044865 -3.168901311495498e-09 -0.09997026829943023 -2.9009 0.7070548526254616 0.7070536203348861 -2.6998678509873586e-09 -0.09997027733002524 -2.901 0.7070548690254814 0.7070536358555158 -2.240297544697789e-09 -0.09997028635787776 -2.9011000000000005 0.7070548854254713 0.7070536513664802 -1.7902935601013525e-09 -0.09997029538298854 -2.9012000000000002 0.7070549018253295 0.707053666867885 -1.3499568190730726e-09 -0.09997030440535852 -2.9013 0.7070549182249521 0.7070536823598366 -9.193859866127307e-10 -0.09997031342498852 -2.9014 0.7070549346242344 0.7070536978424424 -4.986774448240139e-10 -0.09997032244187931 -2.9015 0.7070549510230708 0.707053713315811 -8.792527036310949e-11 -0.09997033145603172 -2.9016 0.707054967421355 0.7070537287800522 3.127787889800615e-10 -0.09997034046744668 -2.9017000000000004 0.7070549838189789 0.7070537442352764 7.033453281596325e-10 -0.09997034947612493 -2.9018 0.7070550002158341 0.7070537596815953 1.0836873100272815e-09 -0.09997035848206731 -2.9019 0.7070550166118111 0.7070537751191208 1.4537200809447426e-09 -0.09997036748527464 -2.902 0.7070550330068001 0.7070537905479666 1.8133613950699345e-09 -0.09997037648574784 -2.9021000000000003 0.7070550494006894 0.7070538059682463 2.162531426500025e-09 -0.09997038548348762 -2.9022 0.7070550657933672 0.7070538213800749 2.5011527874860273e-09 -0.09997039447849485 -2.9023000000000003 0.707055082184721 0.7070538367835684 2.8291505527189287e-09 -0.09997040347077041 -2.9024 0.7070550985746369 0.7070538521788432 3.1464522662685845e-09 -0.09997041246031509 -2.9025 0.7070551149630004 0.7070538675660163 3.4529879650024853e-09 -0.09997042144712964 -2.9026000000000005 0.707055131349697 0.707053882945206 3.748690186392012e-09 -0.09997043043121503 -2.9027000000000003 0.707055147734611 0.7070538983165309 4.033493994533288e-09 -0.09997043941257208 -2.9028 0.7070551641176255 0.7070539136801101 4.307336986218713e-09 -0.09997044839120153 -2.9029000000000003 0.7070551804986237 0.7070539290360636 4.570159302212662e-09 -0.09997045736710425 -2.903 0.7070551968774882 0.7070539443845122 4.821903648935533e-09 -0.09997046634028106 -2.9031000000000002 0.7070552132541004 0.7070539597255768 5.06251530193319e-09 -0.09997047531073278 -2.9032000000000004 0.7070552296283416 0.7070539750593792 5.291942125826288e-09 -0.09997048427846023 -2.9033 0.7070552460000927 0.7070539903860418 5.510134579514436e-09 -0.09997049324346431 -2.9034 0.7070552623692337 0.7070540057056871 5.717045731788717e-09 -0.09997050220574577 -2.9035 0.7070552787356446 0.7070540210184382 5.912631263933765e-09 -0.09997051116530546 -2.9036000000000004 0.7070552950992042 0.7070540363244192 6.096849485340283e-09 -0.09997052012214419 -2.9037 0.7070553114597917 0.7070540516237536 6.26966134391338e-09 -0.09997052907626279 -2.9038000000000004 0.7070553278172855 0.7070540669165662 6.431030427807294e-09 -0.0999705380276621 -2.9039 0.7070553441715637 0.7070540822029816 6.58092297756846e-09 -0.09997054697634294 -2.904 0.7070553605225043 0.7070540974831252 6.7193078913396764e-09 -0.09997055592230616 -2.9041000000000006 0.7070553768699845 0.7070541127571224 6.846156732666364e-09 -0.09997056486555257 -2.9042000000000003 0.7070553932138817 0.7070541280250984 6.961443735700734e-09 -0.09997057380608296 -2.9043 0.7070554095540729 0.7070541432871797 7.0651458104059595e-09 -0.0999705827438982 -2.9044 0.7070554258904347 0.7070541585434925 7.1572425434235365e-09 -0.09997059167899913 -2.9045 0.7070554422228434 0.7070541737941627 7.237716211083711e-09 -0.09997060061138649 -2.9046000000000003 0.7070554585511758 0.707054189039317 7.3065517715992234e-09 -0.09997060954106113 -2.9047 0.7070554748753084 0.7070542042790824 7.363736875473648e-09 -0.09997061846802396 -2.9048000000000003 0.707055491195117 0.7070542195135849 7.409261865501393e-09 -0.09997062739227575 -2.9049 0.7070555075104776 0.707054234742952 7.443119775900342e-09 -0.09997063631381728 -2.905 0.7070555238212667 0.7070542499673101 7.465306334913935e-09 -0.09997064523264941 -2.9051000000000005 0.7070555401273599 0.7070542651867863 7.475819966545894e-09 -0.09997065414877297 -2.9052000000000002 0.7070555564286336 0.7070542804015072 7.474661787090775e-09 -0.09997066306218874 -2.9053 0.7070555727249636 0.7070542956115995 7.461835607736056e-09 -0.09997067197289755 -2.9054 0.7070555890162264 0.7070543108171905 7.437347930225324e-09 -0.09997068088090028 -2.9055 0.7070556053022983 0.7070543260184063 7.4012079373173e-09 -0.09997068978619775 -2.9056 0.7070556215830557 0.7070543412153736 7.353427509265709e-09 -0.09997069868879072 -2.9057000000000004 0.7070556378583752 0.7070543564082188 7.29402120386996e-09 -0.0999707075886801 -2.9058 0.7070556541281333 0.7070543715970676 7.223006256475151e-09 -0.0999707164858666 -2.9059 0.7070556703922071 0.7070543867820465 7.140402573033167e-09 -0.09997072538035111 -2.906 0.707055686650474 0.7070544019632806 7.0462327353068566e-09 -0.0999707342721344 -2.9061000000000003 0.7070557029028115 0.7070544171408957 6.940521977451264e-09 -0.09997074316121735 -2.9062 0.7070557191490969 0.7070544323150167 6.823298190350435e-09 -0.09997075204760072 -2.9063000000000003 0.7070557353892091 0.7070544474857681 6.694591920750059e-09 -0.09997076093128533 -2.9064 0.7070557516230263 0.7070544626532747 6.554436346103976e-09 -0.0999707698122721 -2.9065 0.7070557678504273 0.7070544778176603 6.402867282380431e-09 -0.09997077869056173 -2.9066000000000005 0.7070557840712917 0.7070544929790484 6.239923162378036e-09 -0.09997078756615509 -2.9067000000000003 0.707055800285499 0.7070545081375623 6.065645034858402e-09 -0.099970796439053 -2.9068 0.7070558164929297 0.707054523293325 5.8800765524030796e-09 -0.09997080530925634 -2.9069000000000003 0.7070558326934643 0.7070545384464582 5.683263951464235e-09 -0.09997081417676584 -2.907 0.707055848886984 0.7070545535970834 5.475256060170908e-09 -0.09997082304158231 -2.9071000000000002 0.7070558650733709 0.707054568745322 5.2561042697060745e-09 -0.09997083190370666 -2.9072000000000005 0.7070558812525073 0.7070545838912943 5.025862528235114e-09 -0.09997084076313961 -2.9073 0.707055897424276 0.7070545990351202 4.784587323558576e-09 -0.09997084961988201 -2.9074 0.7070559135885607 0.707054614176919 4.532337677040643e-09 -0.09997085847393467 -2.9075 0.707055929745246 0.7070546293168092 4.269175116720925e-09 -0.09997086732529842 -2.9076000000000004 0.7070559458942167 0.7070546444549086 3.995163676447089e-09 -0.09997087617397407 -2.9077 0.7070559620353585 0.7070546595913347 3.71036986811929e-09 -0.09997088501996246 -2.9078000000000004 0.7070559781685581 0.7070546747262038 3.414862676485997e-09 -0.09997089386326438 -2.9079 0.7070559942937026 0.7070546898596312 3.10871353225578e-09 -0.09997090270388063 -2.908 0.70705601041068 0.7070547049917318 2.7919963103625878e-09 -0.09997091154181206 -2.9081000000000006 0.7070560265193792 0.70705472012262 2.4647872891997435e-09 -0.09997092037705947 -2.9082000000000003 0.7070560426196901 0.707054735252409 2.1271651445484152e-09 -0.09997092920962375 -2.9083 0.7070560587115028 0.7070547503812108 1.7792109443734438e-09 -0.09997093803950559 -2.9084 0.707056074794709 0.7070547655091368 1.4210081037205335e-09 -0.09997094686670582 -2.9085 0.7070560908692014 0.7070547806362975 1.0526423821141662e-09 -0.09997095569122534 -2.9086000000000003 0.7070561069348731 0.7070547957628026 6.742018592714727e-10 -0.09997096451306492 -2.9087 0.7070561229916185 0.7070548108887602 2.8577690561193414e-10 -0.09997097333222531 -2.9088000000000003 0.7070561390393328 0.7070548260142783 -1.125398255488741e-10 -0.09997098214870744 -2.9089 0.7070561550779126 0.7070548411394633 -5.206534300916665e-10 -0.09997099096251205 -2.909 0.7070561711072552 0.7070548562644204 -9.384667669712354e-10 -0.09997099977363993 -2.9091000000000005 0.7070561871272588 0.7070548713892542 -1.365880493778282e-09 -0.09997100858209193 -2.9092000000000002 0.7070562031378236 0.7070548865140682 -1.8027930762803956e-09 -0.09997101738786891 -2.9093 0.7070562191388496 0.7070549016389645 -2.2491008291880554e-09 -0.09997102619097159 -2.9094 0.7070562351302389 0.7070549167640439 -2.704697920491439e-09 -0.09997103499140081 -2.9095 0.7070562511118946 0.7070549318894064 -3.169476413093786e-09 -0.09997104378915743 -2.9096 0.7070562670837208 0.707054947015151 -3.6433262812912703e-09 -0.09997105258424228 -2.9097000000000004 0.7070562830456228 0.7070549621413749 -4.1261354454674715e-09 -0.09997106137665608 -2.9098 0.7070562989975075 0.7070549772681742 -4.617789782501713e-09 -0.09997107016639968 -2.9099 0.7070563149392823 0.7070549923956444 -5.118173170004514e-09 -0.0999710789534739 -2.91 0.7070563308708567 0.7070550075238788 -5.6271675071342675e-09 -0.09997108773787956 -2.9101000000000004 0.7070563467921409 0.7070550226529698 -6.144652739750733e-09 -0.0999710965196174 -2.9102 0.7070563627030467 0.7070550377830089 -6.67050689164006e-09 -0.09997110529868831 -2.9103000000000003 0.7070563786034872 0.7070550529140857 -7.204606093137722e-09 -0.09997111407509307 -2.9104 0.7070563944933768 0.7070550680462885 -7.746824608884095e-09 -0.09997112284883247 -2.9105 0.7070564103726311 0.7070550831797044 -8.29703486904948e-09 -0.09997113161990731 -2.9106000000000005 0.7070564262411677 0.7070550983144194 -8.855107499691761e-09 -0.09997114038831849 -2.9107000000000003 0.707056442098905 0.7070551134505174 -9.4209113479099e-09 -0.09997114915406671 -2.9108 0.7070564579457628 0.7070551285880813 -9.99431352607938e-09 -0.0999711579171528 -2.9109000000000003 0.7070564737816628 0.7070551437271926 -1.0575179421393188e-08 -0.09997116667757762 -2.911 0.7070564896065282 0.7070551588679312 -1.1163372748770883e-08 -0.099971175435342 -2.9111000000000002 0.7070565054202831 0.7070551740103755 -1.1758755571675272e-08 -0.09997118419044666 -2.9112000000000005 0.7070565212228537 0.7070551891546024 -1.236118833550584e-08 -0.09997119294289247 -2.9113 0.7070565370141672 0.7070552043006875 -1.2970529899257455e-08 -0.09997120169268026 -2.9114 0.7070565527941526 0.7070552194487045 -1.3586637574551641e-08 -0.09997121043981076 -2.9115 0.7070565685627405 0.7070552345987255 -1.4209367153825841e-08 -0.09997121918428481 -2.9116000000000004 0.7070565843198628 0.7070552497508216 -1.4838572944594203e-08 -0.0999712279261032 -2.9117 0.7070566000654537 0.7070552649050617 -1.5474107805443088e-08 -0.09997123666526675 -2.9118000000000004 0.7070566157994479 0.7070552800615133 -1.6115823178557143e-08 -0.09997124540177627 -2.9119 0.7070566315217826 0.7070552952202427 -1.676356912831689e-08 -0.09997125413563254 -2.912 0.7070566472323963 0.7070553103813142 -1.7417194366885907e-08 -0.09997126286683643 -2.9121000000000006 0.7070566629312289 0.7070553255447901 -1.8076546301915714e-08 -0.09997127159538866 -2.9122000000000003 0.7070566786182226 0.7070553407107318 -1.8741471062566628e-08 -0.09997128032129007 -2.9123 0.7070566942933206 0.7070553558791987 -1.941181353984009e-08 -0.0999712890445415 -2.9124 0.7070567099564684 0.7070553710502483 -2.0087417423007847e-08 -0.09997129776514375 -2.9125 0.7070567256076127 0.7070553862239366 -2.0768125233439072e-08 -0.0999713064830976 -2.9126000000000003 0.7070567412467019 0.7070554014003179 -2.1453778361463227e-08 -0.09997131519840385 -2.9127 0.7070567568736865 0.7070554165794447 -2.214421710670239e-08 -0.09997132391106334 -2.9128000000000003 0.7070567724885185 0.707055431761368 -2.283928071059732e-08 -0.09997133262107685 -2.9129 0.7070567880911516 0.7070554469461366 -2.3538807401076584e-08 -0.09997134132844515 -2.913 0.707056803681541 0.7070554621337979 -2.424263441987845e-08 -0.09997135003316901 -2.9131000000000005 0.7070568192596443 0.7070554773243978 -2.495059806982211e-08 -0.09997135873524937 -2.9132000000000002 0.7070568348254206 0.7070554925179797 -2.5662533746032695e-08 -0.09997136743468694 -2.9133 0.7070568503788304 0.7070555077145859 -2.6378275979743043e-08 -0.09997137613148252 -2.9134 0.7070568659198366 0.7070555229142566 -2.7097658472554492e-08 -0.09997138482563694 -2.9135 0.7070568814484035 0.7070555381170303 -2.7820514135468155e-08 -0.099971393517151 -2.9136 0.7070568969644971 0.7070555533229433 -2.854667513333721e-08 -0.09997140220602549 -2.9137000000000004 0.7070569124680857 0.7070555685320308 -2.927597291522456e-08 -0.09997141089226119 -2.9138 0.707056927959139 0.7070555837443259 -3.000823825668672e-08 -0.099971419575859 -2.9139 0.7070569434376287 0.7070555989598595 -3.07433013042261e-08 -0.09997142825681964 -2.914 0.7070569589035282 0.7070556141786608 -3.148099160716657e-08 -0.09997143693514388 -2.9141000000000004 0.7070569743568127 0.7070556294007577 -3.222113816275622e-08 -0.09997144561083258 -2.9142 0.7070569897974596 0.7070556446261758 -3.29635694497777e-08 -0.09997145428388654 -2.9143000000000003 0.7070570052254476 0.7070556598549389 -3.3708113475168847e-08 -0.09997146295430649 -2.9144 0.7070570206407577 0.7070556750870687 -3.4454597809801396e-08 -0.09997147162209329 -2.9145 0.7070570360433728 0.7070556903225856 -3.5202849628162766e-08 -0.09997148028724773 -2.9146000000000005 0.7070570514332775 0.7070557055615077 -3.5952695750856786e-08 -0.09997148894977062 -2.9147000000000003 0.7070570668104579 0.7070557208038512 -3.670396268233393e-08 -0.0999714976096627 -2.9148 0.7070570821749027 0.707055736049631 -3.745647665154891e-08 -0.09997150626692484 -2.9149000000000003 0.7070570975266017 0.7070557512988596 -3.821006365456979e-08 -0.09997151492155783 -2.915 0.7070571128655473 0.7070557665515478 -3.896454948948934e-08 -0.09997152357356245 -2.9151000000000002 0.7070571281917332 0.7070557818077041 -3.971975980103992e-08 -0.09997153222293946 -2.9152000000000005 0.7070571435051554 0.7070557970673365 -4.047552012163055e-08 -0.09997154086968976 -2.9153000000000002 0.7070571588058115 0.7070558123304493 -4.123165590745083e-08 -0.09997154951381411 -2.9154 0.7070571740937011 0.7070558275970459 -4.198799258192036e-08 -0.09997155815531324 -2.9155 0.7070571893688252 0.7070558428671279 -4.274435557504526e-08 -0.099971566794188 -2.9156000000000004 0.7070572046311877 0.7070558581406947 -4.350057036421468e-08 -0.0999715754304392 -2.9157 0.7070572198807934 0.7070558734177439 -4.4256462512794995e-08 -0.09997158406406759 -2.9158000000000004 0.7070572351176494 0.7070558886982714 -4.50118577122714e-08 -0.099971592695074 -2.9159 0.7070572503417645 0.7070559039822709 -4.5766581820432146e-08 -0.09997160132345917 -2.916 0.7070572655531497 0.707055919269735 -4.65204609059462e-08 -0.09997160994922402 -2.9161000000000006 0.7070572807518176 0.707055934560653 -4.7273321281821046e-08 -0.09997161857236919 -2.9162000000000003 0.7070572959377824 0.7070559498550137 -4.802498955122376e-08 -0.09997162719289555 -2.9163 0.707057311111061 0.7070559651528036 -4.877529264312418e-08 -0.09997163581080394 -2.9164 0.7070573262716713 0.7070559804540071 -4.952405785539193e-08 -0.09997164442609507 -2.9165 0.7070573414196333 0.7070559957586069 -5.027111289258087e-08 -0.09997165303876977 -2.9166000000000003 0.707057356554969 0.7070560110665842 -5.1016285906153e-08 -0.09997166164882887 -2.9167 0.7070573716777023 0.707056026377918 -5.1759405535027614e-08 -0.09997167025627315 -2.9168000000000003 0.7070573867878589 0.7070560416925853 -5.2500300939950506e-08 -0.0999716788611034 -2.9169 0.7070574018854656 0.7070560570105615 -5.323880185228308e-08 -0.09997168746332036 -2.917 0.7070574169705524 0.7070560723318206 -5.397473860392632e-08 -0.09997169606292493 -2.9171000000000005 0.7070574320431497 0.7070560876563339 -5.47079421707973e-08 -0.09997170465991782 -2.9172000000000002 0.7070574471032907 0.7070561029840712 -5.543824421142679e-08 -0.0999717132542998 -2.9173 0.70705746215101 0.707056118315001 -5.616547710403895e-08 -0.09997172184607174 -2.9174 0.707057477186344 0.7070561336490897 -5.688947398688367e-08 -0.09997173043523438 -2.9175 0.707057492209331 0.7070561489863018 -5.7610068792497346e-08 -0.09997173902178853 -2.9176 0.7070575072200107 0.7070561643265998 -5.8327096292588865e-08 -0.09997174760573495 -2.9177000000000004 0.7070575222184255 0.7070561796699453 -5.904039213078249e-08 -0.09997175618707455 -2.9178 0.7070575372046183 0.707056195016297 -5.974979286099864e-08 -0.09997176476580794 -2.9179 0.7070575521786346 0.7070562103656126 -6.045513598540095e-08 -0.09997177334193601 -2.918 0.7070575671405215 0.7070562257178481 -6.115625999277702e-08 -0.09997178191545958 -2.9181000000000004 0.7070575820903278 0.7070562410729575 -6.185300439323291e-08 -0.09997179048637944 -2.9182 0.7070575970281036 0.7070562564308933 -6.25452097561402e-08 -0.09997179905469633 -2.9183000000000003 0.7070576119539012 0.7070562717916058 -6.323271774764938e-08 -0.09997180762041104 -2.9184 0.7070576268677744 0.7070562871550443 -6.391537116451698e-08 -0.09997181618352441 -2.9185 0.7070576417697786 0.7070563025211559 -6.459301397313683e-08 -0.09997182474403717 -2.9186000000000005 0.707057656659971 0.7070563178898863 -6.526549134076506e-08 -0.09997183330195013 -2.9187000000000003 0.7070576715384104 0.7070563332611794 -6.593264967671986e-08 -0.09997184185726404 -2.9188 0.7070576864051573 0.7070563486349781 -6.659433666187167e-08 -0.09997185040997981 -2.9189000000000003 0.7070577012602737 0.7070563640112225 -6.725040128420512e-08 -0.09997185896009814 -2.919 0.7070577161038232 0.7070563793898519 -6.790069387785022e-08 -0.09997186750761979 -2.9191000000000003 0.7070577309358711 0.707056394770804 -6.85450661530064e-08 -0.09997187605254564 -2.9192000000000005 0.7070577457564844 0.7070564101540149 -6.918337123107063e-08 -0.09997188459487645 -2.9193000000000002 0.7070577605657311 0.7070564255394185 -6.981546367976557e-08 -0.09997189313461294 -2.9194 0.7070577753636812 0.707056440926948 -7.044119953959413e-08 -0.09997190167175594 -2.9195 0.7070577901504065 0.7070564563165347 -7.106043636460543e-08 -0.09997191020630627 -2.9196000000000004 0.7070578049259799 0.7070564717081085 -7.167303325015043e-08 -0.09997191873826472 -2.9197 0.7070578196904755 0.7070564871015976 -7.227885086931105e-08 -0.09997192726763204 -2.9198000000000004 0.7070578344439696 0.7070565024969289 -7.287775150022213e-08 -0.09997193579440904 -2.9199 0.7070578491865394 0.7070565178940278 -7.34695990559954e-08 -0.09997194431859648 -2.92 0.7070578639182638 0.7070565332928181 -7.405425912331703e-08 -0.09997195284019515 -2.9201000000000006 0.7070578786392226 0.7070565486932225 -7.463159898326438e-08 -0.0999719613592058 -2.9202000000000004 0.707057893349498 0.7070565640951623 -7.520148764903617e-08 -0.0999719698756293 -2.9203 0.7070579080491729 0.7070565794985568 -7.576379589327442e-08 -0.09997197838946639 -2.9204 0.7070579227383316 0.7070565949033247 -7.631839627538634e-08 -0.09997198690071785 -2.9205 0.70705793741706 0.7070566103093827 -7.686516317103459e-08 -0.09997199540938445 -2.9206000000000003 0.7070579520854452 0.7070566257166471 -7.7403972802495e-08 -0.09997200391546707 -2.9207 0.7070579667435752 0.7070566411250316 -7.793470326641211e-08 -0.09997201241896635 -2.9208000000000003 0.7070579813915401 0.7070566565344498 -7.845723455982001e-08 -0.09997202091988315 -2.9209 0.7070579960294308 0.7070566719448133 -7.897144860876532e-08 -0.09997202941821828 -2.921 0.7070580106573396 0.707056687356033 -7.947722929346063e-08 -0.09997203791397258 -2.9211000000000005 0.7070580252753594 0.7070567027680178 -7.997446247170331e-08 -0.09997204640714666 -2.9212000000000002 0.7070580398835852 0.7070567181806762 -8.04630360127026e-08 -0.09997205489774141 -2.9213 0.7070580544821128 0.7070567335939151 -8.094283981876366e-08 -0.09997206338575765 -2.9214 0.7070580690710386 0.70705674900764 -8.141376584697158e-08 -0.09997207187119604 -2.9215 0.7070580836504613 0.707056764421756 -8.187570813347755e-08 -0.09997208035405743 -2.9216 0.7070580982204797 0.7070567798361667 -8.232856282298917e-08 -0.0999720888343426 -2.9217000000000004 0.7070581127811943 0.7070567952507745 -8.277222818871971e-08 -0.09997209731205237 -2.9218 0.7070581273327066 0.7070568106654807 -8.320660464886803e-08 -0.09997210578718746 -2.9219 0.7070581418751185 0.7070568260801857 -8.363159480044569e-08 -0.09997211425974867 -2.922 0.7070581564085336 0.7070568414947891 -8.404710343662414e-08 -0.09997212272973682 -2.9221000000000004 0.7070581709330565 0.7070568569091891 -8.445303756581674e-08 -0.09997213119715266 -2.9222 0.7070581854487923 0.7070568723232828 -8.48493064298933e-08 -0.09997213966199692 -2.9223000000000003 0.7070581999558473 0.7070568877369672 -8.523582153453779e-08 -0.09997214812427047 -2.9224 0.7070582144543289 0.7070569031501378 -8.561249665445247e-08 -0.09997215658397407 -2.9225 0.7070582289443453 0.7070569185626889 -8.59792478723892e-08 -0.09997216504110848 -2.9226000000000005 0.7070582434260053 0.7070569339745143 -8.633599357741467e-08 -0.09997217349567447 -2.9227000000000003 0.7070582578994189 0.7070569493855073 -8.668265449526813e-08 -0.09997218194767288 -2.9228 0.7070582723646968 0.7070569647955596 -8.701915370310648e-08 -0.09997219039710445 -2.9229000000000003 0.7070582868219499 0.7070569802045625 -8.734541664598416e-08 -0.0999721988439699 -2.923 0.707058301271291 0.7070569956124066 -8.766137114986361e-08 -0.09997220728827005 -2.9231000000000003 0.7070583157128334 0.7070570110189816 -8.796694744503397e-08 -0.09997221573000573 -2.9232000000000005 0.70705833014669 0.7070570264241767 -8.826207817565213e-08 -0.09997222416917767 -2.9233000000000002 0.7070583445729757 0.70705704182788 -8.854669841882462e-08 -0.09997223260578664 -2.9234 0.7070583589918051 0.7070570572299795 -8.882074568981185e-08 -0.09997224103983343 -2.9235 0.7070583734032947 0.707057072630362 -8.908415997325309e-08 -0.09997224947131887 -2.9236000000000004 0.7070583878075603 0.7070570880289142 -8.933688371709492e-08 -0.09997225790024368 -2.9237 0.7070584022047186 0.7070571034255215 -8.95788618525406e-08 -0.09997226632660859 -2.9238000000000004 0.7070584165948872 0.7070571188200696 -8.981004181486674e-08 -0.09997227475041445 -2.9239 0.7070584309781847 0.7070571342124434 -9.003037353908644e-08 -0.0999722831716621 -2.924 0.707058445354729 0.7070571496025266 -9.02398094772966e-08 -0.09997229159035222 -2.9241 0.707058459724639 0.7070571649902033 -9.043830461949454e-08 -0.09997230000648556 -2.9242000000000004 0.7070584740880346 0.7070571803753569 -9.062581648490442e-08 -0.09997230842006301 -2.9243 0.7070584884450353 0.7070571957578703 -9.0802305145396e-08 -0.09997231683108529 -2.9244 0.7070585027957612 0.7070572111376255 -9.096773322461726e-08 -0.0999723252395531 -2.9245 0.7070585171403332 0.707057226514505 -9.112206591187222e-08 -0.09997233364546726 -2.9246000000000003 0.7070585314788722 0.7070572418883907 -9.126527096472298e-08 -0.09997234204882861 -2.9247 0.7070585458114996 0.7070572572591638 -9.139731872026546e-08 -0.09997235044963788 -2.9248000000000003 0.7070585601383368 0.7070572726267055 -9.151818209512941e-08 -0.09997235884789583 -2.9249 0.7070585744595057 0.7070572879908968 -9.162783660282559e-08 -0.09997236724360326 -2.925 0.7070585887751284 0.7070573033516185 -9.172626033986803e-08 -0.09997237563676094 -2.9251000000000005 0.707058603085327 0.7070573187087508 -9.18134340065907e-08 -0.0999723840273696 -2.9252000000000002 0.707058617390224 0.707057334062174 -9.188934090888223e-08 -0.09997239241543007 -2.9253 0.7070586316899421 0.7070573494117687 -9.19539669495123e-08 -0.09997240080094313 -2.9254000000000002 0.707058645984604 0.7070573647574148 -9.20073006420094e-08 -0.09997240918390955 -2.9255 0.7070586602743323 0.7070573800989919 -9.20493331080588e-08 -0.09997241756433008 -2.9256 0.7070586745592499 0.7070573954363801 -9.208005808183928e-08 -0.09997242594220546 -2.9257000000000004 0.7070586888394799 0.7070574107694596 -9.209947190742113e-08 -0.09997243431753657 -2.9258 0.7070587031151447 0.7070574260981095 -9.210757353703136e-08 -0.09997244269032407 -2.9259 0.7070587173863676 0.7070574414222102 -9.210436453539056e-08 -0.09997245106056878 -2.926 0.7070587316532712 0.7070574567416414 -9.208984908058021e-08 -0.09997245942827143 -2.9261000000000004 0.7070587459159785 0.7070574720562832 -9.206403394929757e-08 -0.09997246779343284 -2.9262 0.7070587601746119 0.7070574873660156 -9.202692852899874e-08 -0.0999724761560538 -2.9263000000000003 0.7070587744292938 0.7070575026707189 -9.197854480835765e-08 -0.09997248451613502 -2.9264 0.7070587886801469 0.7070575179702735 -9.191889737553138e-08 -0.09997249287367733 -2.9265 0.707058802927293 0.7070575332645601 -9.184800341122124e-08 -0.09997250122868147 -2.9266000000000005 0.7070588171708541 0.707057548553459 -9.176588268954011e-08 -0.09997250958114817 -2.9267000000000003 0.7070588314109519 0.7070575638368517 -9.167255756326737e-08 -0.09997251793107824 -2.9268 0.7070588456477083 0.7070575791146193 -9.156805296645087e-08 -0.0999725262784725 -2.9269000000000003 0.7070588598812437 0.7070575943866437 -9.14523964066008e-08 -0.0999725346233317 -2.927 0.7070588741116793 0.7070576096528067 -9.132561795428124e-08 -0.09997254296565655 -2.9271000000000003 0.7070588883391355 0.7070576249129904 -9.118775023703868e-08 -0.09997255130544788 -2.9272000000000005 0.7070589025637324 0.7070576401670775 -9.103882843072841e-08 -0.09997255964270642 -2.9273000000000002 0.7070589167855891 0.7070576554149512 -9.08788902551777e-08 -0.09997256797743292 -2.9274 0.7070589310048251 0.707057670656495 -9.07079759533691e-08 -0.09997257630962816 -2.9275 0.7070589452215597 0.7070576858915928 -9.052612829404255e-08 -0.09997258463929298 -2.9276000000000004 0.7070589594359105 0.7070577011201291 -9.03333925552155e-08 -0.09997259296642808 -2.9277 0.7070589736479953 0.707057716341989 -9.012981651117247e-08 -0.09997260129103425 -2.9278000000000004 0.7070589878579316 0.7070577315570578 -8.991545042552618e-08 -0.09997260961311222 -2.9279 0.7070590020658356 0.7070577467652219 -8.969034703213558e-08 -0.09997261793266282 -2.928 0.7070590162718235 0.7070577619663676 -8.945456153250375e-08 -0.09997262624968674 -2.9281 0.7070590304760109 0.7070577771603825 -8.920815156802236e-08 -0.0999726345641848 -2.9282000000000004 0.7070590446785122 0.7070577923471546 -8.895117721997164e-08 -0.09997264287615776 -2.9283 0.7070590588794416 0.7070578075265725 -8.868370098696898e-08 -0.09997265118560641 -2.9284 0.7070590730789128 0.7070578226985258 -8.840578777022379e-08 -0.09997265949253152 -2.9285 0.7070590872770379 0.707057837862904 -8.811750486312914e-08 -0.09997266779693378 -2.9286000000000003 0.7070591014739291 0.7070578530195983 -8.78189219304451e-08 -0.09997267609881408 -2.9287 0.7070591156696975 0.7070578681685006 -8.751011099095152e-08 -0.0999726843981731 -2.9288000000000003 0.7070591298644532 0.7070578833095026 -8.719114640096809e-08 -0.09997269269501158 -2.9289 0.7070591440583058 0.7070578984424978 -8.686210483787454e-08 -0.09997270098933034 -2.929 0.7070591582513641 0.7070579135673805 -8.652306528102865e-08 -0.09997270928113017 -2.9291000000000005 0.7070591724437357 0.7070579286840453 -8.61741089926843e-08 -0.09997271757041173 -2.9292000000000002 0.7070591866355271 0.7070579437923884 -8.581531949804211e-08 -0.09997272585717587 -2.9293 0.7070592008268446 0.7070579588923063 -8.54467825653002e-08 -0.09997273414142328 -2.9294000000000002 0.7070592150177932 0.7070579739836973 -8.506858618830687e-08 -0.09997274242315488 -2.9295 0.7070592292084767 0.7070579890664592 -8.468082055793774e-08 -0.09997275070237123 -2.9296 0.7070592433989982 0.7070580041404922 -8.428357805342207e-08 -0.0999727589790732 -2.9297000000000004 0.7070592575894594 0.7070580192056972 -8.387695320504623e-08 -0.09997276725326154 -2.9298 0.7070592717799618 0.7070580342619757 -8.346104267854121e-08 -0.09997277552493705 -2.9299 0.7070592859706051 0.7070580493092307 -8.303594525773533e-08 -0.09997278379410048 -2.93 0.7070593001614878 0.7070580643473658 -8.260176181853346e-08 -0.09997279206075255 -2.9301000000000004 0.7070593143527077 0.7070580793762864 -8.21585952959572e-08 -0.09997280032489406 -2.9302 0.7070593285443616 0.7070580943958986 -8.17065506693998e-08 -0.0999728085865258 -2.9303000000000003 0.7070593427365446 0.7070581094061095 -8.124573493920734e-08 -0.09997281684564845 -2.9304 0.7070593569293508 0.7070581244068276 -8.077625708764746e-08 -0.09997282510226281 -2.9305 0.7070593711228738 0.7070581393979628 -8.02982280676337e-08 -0.09997283335636968 -2.9306000000000005 0.7070593853172049 0.7070581543794259 -7.981176077323515e-08 -0.0999728416079698 -2.9307000000000003 0.7070593995124346 0.7070581693511286 -7.931697000845145e-08 -0.0999728498570639 -2.9308 0.7070594137086521 0.7070581843129848 -7.881397246119193e-08 -0.09997285810365267 -2.9309000000000003 0.7070594279059462 0.707058199264909 -7.830288668419366e-08 -0.09997286634773705 -2.931 0.7070594421044031 0.7070582142068171 -7.778383305425546e-08 -0.0999728745893177 -2.9311000000000003 0.7070594563041082 0.7070582291386263 -7.725693375142118e-08 -0.09997288282839537 -2.9312000000000005 0.7070594705051455 0.7070582440602554 -7.672231273035679e-08 -0.09997289106497083 -2.9313000000000002 0.7070594847075979 0.7070582589716244 -7.618009568999273e-08 -0.09997289929904486 -2.9314 0.7070594989115471 0.7070582738726546 -7.563041003882942e-08 -0.09997290753061826 -2.9315 0.7070595131170723 0.7070582887632686 -7.507338487932474e-08 -0.09997291575969168 -2.9316000000000004 0.7070595273242526 0.7070583036433904 -7.450915095888813e-08 -0.09997292398626595 -2.9317 0.7070595415331651 0.7070583185129459 -7.393784065253331e-08 -0.09997293221034184 -2.9318 0.7070595557438852 0.7070583333718616 -7.335958792818384e-08 -0.09997294043192007 -2.9319 0.7070595699564874 0.7070583482200665 -7.277452831588177e-08 -0.0999729486510014 -2.932 0.7070595841710445 0.7070583630574903 -7.218279887222581e-08 -0.09997295686758664 -2.9321 0.7070595983876276 0.7070583778840642 -7.158453815348312e-08 -0.09997296508167647 -2.9322000000000004 0.7070596126063062 0.7070583926997214 -7.097988617742537e-08 -0.09997297329327165 -2.9323 0.7070596268271492 0.707058407504396 -7.03689843981753e-08 -0.09997298150237302 -2.9324 0.7070596410502228 0.7070584222980243 -6.975197566674168e-08 -0.09997298970898127 -2.9325 0.7070596552755923 0.7070584370805437 -6.912900420152912e-08 -0.0999729979130972 -2.9326000000000003 0.7070596695033211 0.7070584518518935 -6.850021555017405e-08 -0.09997300611472153 -2.9327 0.7070596837334717 0.7070584666120141 -6.786575656265656e-08 -0.09997301431385502 -2.9328000000000003 0.7070596979661041 0.7070584813608478 -6.722577534706495e-08 -0.09997302251049846 -2.9329 0.7070597122012776 0.7070584960983388 -6.65804212427075e-08 -0.09997303070465263 -2.933 0.7070597264390488 0.707058510824432 -6.592984478671904e-08 -0.09997303889631821 -2.9331000000000005 0.7070597406794734 0.7070585255390752 -6.527419767112658e-08 -0.09997304708549602 -2.9332000000000003 0.7070597549226054 0.7070585402422167 -6.461363271639473e-08 -0.09997305527218678 -2.9333 0.7070597691684968 0.7070585549338069 -6.394830382719027e-08 -0.09997306345639118 -2.9334000000000002 0.7070597834171984 0.7070585696137979 -6.327836596072348e-08 -0.09997307163811003 -2.9335 0.7070597976687591 0.7070585842821437 -6.260397509292095e-08 -0.09997307981734416 -2.9336 0.7070598119232263 0.7070585989387997 -6.192528817852705e-08 -0.09997308799409423 -2.9337000000000004 0.7070598261806451 0.7070586135837231 -6.124246311597567e-08 -0.09997309616836102 -2.9338 0.7070598404410595 0.7070586282168723 -6.055565871182847e-08 -0.09997310434014528 -2.9339 0.7070598547045116 0.7070586428382084 -5.986503464347828e-08 -0.09997311250944776 -2.934 0.707059868971042 0.7070586574476934 -5.917075141621472e-08 -0.09997312067626923 -2.9341000000000004 0.7070598832406889 0.7070586720452913 -5.847297033546861e-08 -0.09997312884061042 -2.9342 0.7070598975134895 0.7070586866309679 -5.7771853461275474e-08 -0.09997313700247211 -2.9343000000000004 0.7070599117894791 0.7070587012046912 -5.7067563577917896e-08 -0.09997314516185507 -2.9344 0.7070599260686907 0.7070587157664299 -5.636026414947322e-08 -0.09997315331876003 -2.9345 0.7070599403511559 0.7070587303161553 -5.565011928663696e-08 -0.09997316147318772 -2.9346000000000005 0.7070599546369051 0.7070587448538403 -5.493729370617366e-08 -0.09997316962513897 -2.9347000000000003 0.7070599689259658 0.7070587593794593 -5.4221952694270825e-08 -0.09997317777461445 -2.9348 0.7070599832183644 0.7070587738929887 -5.350426206533927e-08 -0.09997318592161492 -2.9349000000000003 0.7070599975141254 0.7070587883944064 -5.278438812666812e-08 -0.09997319406614112 -2.935 0.7070600118132718 0.7070588028836929 -5.206249763852616e-08 -0.09997320220819386 -2.9351000000000003 0.7070600261158242 0.7070588173608295 -5.133875777686529e-08 -0.09997321034777384 -2.9352000000000005 0.7070600404218019 0.7070588318258 -5.061333609320505e-08 -0.09997321848488186 -2.9353000000000002 0.707060054731222 0.7070588462785895 -4.9886400474083437e-08 -0.0999732266195186 -2.9354 0.7070600690441005 0.7070588607191853 -4.91581191076635e-08 -0.09997323475168489 -2.9355 0.7070600833604501 0.7070588751475766 -4.84286604411242e-08 -0.09997324288138142 -2.9356000000000004 0.7070600976802834 0.7070588895637537 -4.7698193139677526e-08 -0.09997325100860892 -2.9357 0.7070601120036104 0.7070589039677095 -4.696688605111514e-08 -0.09997325913336819 -2.9358 0.7070601263304392 0.7070589183594385 -4.623490816759021e-08 -0.09997326725566001 -2.9359 0.7070601406607766 0.7070589327389367 -4.5502428583387745e-08 -0.09997327537548512 -2.936 0.7070601549946268 0.7070589471062021 -4.4769616456435436e-08 -0.09997328349284418 -2.9361 0.7070601693319928 0.7070589614612348 -4.403664097054629e-08 -0.09997329160773803 -2.9362000000000004 0.7070601836728755 0.7070589758040362 -4.3303671296766834e-08 -0.09997329972016737 -2.9363 0.7070601980172739 0.7070589901346098 -4.257087655292621e-08 -0.09997330783013297 -2.9364 0.7070602123651855 0.707059004452961 -4.1838425765631506e-08 -0.09997331593763553 -2.9365 0.7070602267166057 0.7070590187590973 -4.110648782899352e-08 -0.09997332404267587 -2.9366000000000003 0.7070602410715287 0.7070590330530271 -4.0375231469627366e-08 -0.09997333214525472 -2.9367 0.7070602554299457 0.7070590473347612 -3.9644825204426196e-08 -0.09997334024537277 -2.9368000000000003 0.707060269791847 0.7070590616043122 -3.891543730430479e-08 -0.09997334834303082 -2.9369 0.7070602841572212 0.7070590758616948 -3.8187235751698835e-08 -0.09997335643822965 -2.937 0.7070602985260546 0.7070590901069246 -3.74603882066565e-08 -0.09997336453096989 -2.9371000000000005 0.7070603128983317 0.7070591043400198 -3.673506196542192e-08 -0.09997337262125237 -2.9372000000000003 0.7070603272740357 0.707059118561 -3.6011423922162854e-08 -0.09997338070907782 -2.9373 0.7070603416531477 0.7070591327698874 -3.528964053140307e-08 -0.09997338879444707 -2.9374000000000002 0.707060356035647 0.7070591469667045 -3.456987776725637e-08 -0.09997339687736079 -2.9375 0.707060370421511 0.7070591611514765 -3.385230108970787e-08 -0.09997340495781966 -2.9376 0.7070603848107158 0.7070591753242305 -3.3137075402438557e-08 -0.09997341303582453 -2.9377000000000004 0.7070603992032354 0.7070591894849951 -3.242436501823924e-08 -0.09997342111137614 -2.9378 0.7070604135990414 0.7070592036338006 -3.171433361867822e-08 -0.09997342918447516 -2.9379 0.7070604279981048 0.7070592177706789 -3.100714421658789e-08 -0.09997343725512235 -2.938 0.7070604424003943 0.7070592318956643 -3.030295912050292e-08 -0.09997344532331849 -2.9381000000000004 0.7070604568058771 0.7070592460087923 -2.9601939898014212e-08 -0.09997345338906435 -2.9382 0.7070604712145184 0.7070592601101 -2.8904247334352387e-08 -0.0999734614523606 -2.9383000000000004 0.7070604856262817 0.7070592741996267 -2.8210041401596428e-08 -0.09997346951320801 -2.9384 0.707060500041129 0.7070592882774125 -2.7519481214655084e-08 -0.09997347757160735 -2.9385 0.7070605144590205 0.7070593023435008 -2.683272500286077e-08 -0.0999734856275594 -2.9386000000000005 0.7070605288799144 0.7070593163979352 -2.6149930066818317e-08 -0.09997349368106478 -2.9387000000000003 0.7070605433037678 0.7070593304407613 -2.547125274891468e-08 -0.09997350173212427 -2.9388 0.707060557730536 0.7070593444720271 -2.4796848390601367e-08 -0.09997350978073873 -2.9389000000000003 0.7070605721601723 0.7070593584917818 -2.412687130247046e-08 -0.09997351782690884 -2.939 0.7070605865926283 0.7070593725000756 -2.3461474725657017e-08 -0.09997352587063527 -2.9391000000000003 0.7070606010278546 0.707059386496961 -2.2800810796710924e-08 -0.09997353391191881 -2.9392000000000005 0.7070606154657998 0.7070594004824925 -2.214503051593819e-08 -0.09997354195076025 -2.9393000000000002 0.7070606299064104 0.7070594144567255 -2.1494283711839118e-08 -0.09997354998716024 -2.9394 0.7070606443496322 0.7070594284197169 -2.0848719004245425e-08 -0.09997355802111958 -2.9395 0.7070606587954089 0.707059442371526 -2.0208483772227864e-08 -0.09997356605263896 -2.9396000000000004 0.7070606732436826 0.7070594563122129 -1.9573724120269115e-08 -0.0999735740817192 -2.9397 0.7070606876943945 0.7070594702418396 -1.894458484703876e-08 -0.09997358210836099 -2.9398 0.7070607021474831 0.7070594841604696 -1.832120940983145e-08 -0.09997359013256506 -2.9399 0.7070607166028864 0.7070594980681677 -1.7703739889005088e-08 -0.09997359815433216 -2.94 0.7070607310605403 0.7070595119650007 -1.7092316964562038e-08 -0.09997360617366306 -2.9401 0.7070607455203796 0.7070595258510368 -1.6487079876250504e-08 -0.09997361419055846 -2.9402000000000004 0.7070607599823373 0.7070595397263448 -1.5888166392339503e-08 -0.09997362220501911 -2.9403 0.7070607744463453 0.707059553590996 -1.5295712783164328e-08 -0.09997363021704579 -2.9404 0.7070607889123339 0.7070595674450627 -1.4709853786432081e-08 -0.0999736382266392 -2.9405 0.7070608033802319 0.7070595812886189 -1.4130722575996651e-08 -0.09997364623380013 -2.9406000000000003 0.7070608178499661 0.7070595951217398 -1.3558450735404182e-08 -0.09997365423852923 -2.9407 0.7070608323214631 0.7070596089445018 -1.2993168221463874e-08 -0.09997366224082732 -2.9408000000000003 0.7070608467946473 0.707059622756983 -1.2435003342130269e-08 -0.09997367024069509 -2.9409 0.707060861269442 0.7070596365592627 -1.1884082725278217e-08 -0.09997367823813329 -2.941 0.7070608757457689 0.7070596503514217 -1.1340531285309458e-08 -0.0999736862331426 -2.9411000000000005 0.7070608902235491 0.7070596641335416 -1.0804472201468573e-08 -0.09997369422572386 -2.9412000000000003 0.7070609047027019 0.7070596779057062 -1.0276026884015882e-08 -0.09997370221587777 -2.9413 0.7070609191831447 0.7070596916679999 -9.755314955145478e-09 -0.09997371020360503 -2.9414000000000002 0.7070609336647946 0.7070597054205082 -9.242454209953954e-09 -0.09997371818890638 -2.9415 0.7070609481475673 0.7070597191633188 -8.737560597792127e-09 -0.09997372617178261 -2.9416 0.7070609626313767 0.7070597328965198 -8.24074819667786e-09 -0.09997373415223444 -2.9417000000000004 0.7070609771161362 0.7070597466202004 -7.752129181637368e-09 -0.09997374213026253 -2.9418 0.7070609916017577 0.7070597603344515 -7.271813811694783e-09 -0.09997375010586769 -2.9419 0.7070610060881521 0.7070597740393652 -6.799910385636709e-09 -0.09997375807905073 -2.942 0.7070610205752289 0.7070597877350341 -6.336525236808055e-09 -0.09997376604981227 -2.9421000000000004 0.7070610350628965 0.7070598014215526 -5.881762696682835e-09 -0.09997377401815308 -2.9422 0.7070610495510623 0.7070598150990155 -5.435725074047493e-09 -0.09997378198407386 -2.9423000000000004 0.7070610640396326 0.7070598287675196 -4.998512637653663e-09 -0.09997378994757544 -2.9424 0.7070610785285127 0.7070598424271619 -4.570223587595235e-09 -0.09997379790865844 -2.9425 0.7070610930176068 0.7070598560780407 -4.150954034491672e-09 -0.09997380586732363 -2.9426000000000005 0.7070611075068183 0.7070598697202555 -3.74079797953869e-09 -0.09997381382357177 -2.9427000000000003 0.7070611219960494 0.7070598833539068 -3.3398472945589397e-09 -0.09997382177740363 -2.9428 0.7070611364852013 0.7070598969790955 -2.9481916951137888e-09 -0.09997382972881988 -2.9429000000000003 0.7070611509741742 0.7070599105959241 -2.5659187309623466e-09 -0.09997383767782121 -2.943 0.707061165462868 0.7070599242044957 -2.193113751366993e-09 -0.09997384562440846 -2.9431000000000003 0.7070611799511809 0.7070599378049145 -1.8298599033586549e-09 -0.09997385356858234 -2.9432000000000005 0.7070611944390105 0.707059951397285 -1.4762381057159546e-09 -0.09997386151034349 -2.9433000000000002 0.707061208926254 0.7070599649817131 -1.132327023811719e-09 -0.0999738694496927 -2.9434 0.7070612234128072 0.7070599785583057 -7.982030600720003e-10 -0.09997387738663077 -2.9435 0.7070612378985655 0.70705999212717 -4.739403418330124e-10 -0.09997388532115838 -2.9436000000000004 0.7070612523834232 0.707060005688414 -1.5961069098346936e-10 -0.09997389325327627 -2.9437 0.707061266867274 0.7070600192421466 1.4471638470903159e-10 -0.09997390118298513 -2.9438 0.707061281350011 0.7070600327884773 4.3897370027162763e-10 -0.09997390911028571 -2.9439 0.7070612958315265 0.7070600463275167 7.230964160775954e-10 -0.0999739170351788 -2.944 0.7070613103117123 0.7070600598593753 9.97022055193586e-10 -0.09997392495766506 -2.9441 0.707061324790459 0.707060073384165 1.2606905094511567e-09 -0.09997393287774525 -2.9442000000000004 0.7070613392676574 0.7070600869019977 1.5140440533245592e-09 -0.09997394079542006 -2.9443 0.707061353743197 0.7070601004129866 1.7570273638800593e-09 -0.09997394871069032 -2.9444 0.7070613682169672 0.7070601139172444 1.9895875199085755e-09 -0.0999739566235566 -2.9445 0.7070613826888565 0.7070601274148857 2.2116740314159777e-09 -0.09997396453401976 -2.9446000000000003 0.7070613971587534 0.7070601409060246 2.4232388326841936e-09 -0.09997397244208052 -2.9447 0.7070614116265455 0.707060154390776 2.62423630308789e-09 -0.09997398034773958 -2.9448000000000003 0.7070614260921195 0.7070601678692552 2.8146232714312824e-09 -0.09997398825099763 -2.9449 0.7070614405553627 0.7070601813415778 2.9943590332953685e-09 -0.09997399615185538 -2.945 0.7070614550161618 0.7070601948078605 3.1634053458337585e-09 -0.09997400405031376 -2.9451000000000005 0.7070614694744024 0.7070602082682197 3.3217264537935276e-09 -0.09997401194637334 -2.9452000000000003 0.7070614839299703 0.7070602217227722 3.4692890817089594e-09 -0.09997401984003487 -2.9453 0.7070614983827503 0.707060235171635 3.606062446044611e-09 -0.09997402773129901 -2.9454000000000002 0.7070615128326281 0.707060248614926 3.732018265603654e-09 -0.0999740356201666 -2.9455 0.7070615272794885 0.7070602620527627 3.847130761527873e-09 -0.09997404350663831 -2.9456 0.7070615417232153 0.7070602754852635 3.9513766659712846e-09 -0.09997405139071487 -2.9457000000000004 0.7070615561636935 0.7070602889125461 4.044735223834861e-09 -0.09997405927239698 -2.9458 0.707061570600807 0.7070603023347302 4.1271881971033375e-09 -0.0999740671516855 -2.9459 0.7070615850344395 0.7070603157519332 4.19871987351883e-09 -0.09997407502858101 -2.946 0.7070615994644748 0.7070603291642743 4.25931706311139e-09 -0.09997408290308424 -2.9461000000000004 0.7070616138907968 0.7070603425718723 4.308969103403171e-09 -0.09997409077519598 -2.9462 0.7070616283132893 0.7070603559748465 4.3476678602757945e-09 -0.09997409864491698 -2.9463000000000004 0.7070616427318355 0.7070603693733155 4.3754077314397954e-09 -0.09997410651224789 -2.9464 0.7070616571463189 0.7070603827673987 4.3921856377610036e-09 -0.09997411437718945 -2.9465 0.7070616715566231 0.7070603961572148 4.39800104060778e-09 -0.09997412223974242 -2.9466000000000006 0.7070616859626319 0.7070604095428832 4.392855925371142e-09 -0.09997413009990753 -2.9467000000000003 0.7070617003642288 0.7070604229245226 4.376754801464766e-09 -0.09997413795768552 -2.9468 0.7070617147612971 0.707060436302252 4.34970470926388e-09 -0.09997414581307706 -2.9469000000000003 0.7070617291537211 0.7070604496761903 4.311715220105261e-09 -0.09997415366608295 -2.947 0.7070617435413844 0.7070604630464559 4.262798414603197e-09 -0.09997416151670384 -2.9471000000000003 0.7070617579241711 0.7070604764131672 4.202968899129356e-09 -0.09997416936494044 -2.9472000000000005 0.7070617723019654 0.7070604897764425 4.132243791067636e-09 -0.09997417721079349 -2.9473000000000003 0.7070617866746519 0.7070605031364003 4.050642713609998e-09 -0.09997418505426375 -2.9474 0.7070618010421152 0.7070605164931583 3.958187797491186e-09 -0.09997419289535195 -2.9475 0.7070618154042405 0.7070605298468338 3.854903671447751e-09 -0.09997420073405874 -2.9476000000000004 0.7070618297609128 0.7070605431975441 3.740817451809708e-09 -0.09997420857038489 -2.9477 0.707061844112018 0.7070605565454064 3.6159587407658123e-09 -0.09997421640433114 -2.9478 0.7070618584574418 0.7070605698905371 3.4803596194246667e-09 -0.09997422423589819 -2.9479 0.7070618727970706 0.7070605832330525 3.3340546313348485e-09 -0.09997423206508675 -2.948 0.7070618871307912 0.7070605965730683 3.1770807850869942e-09 -0.09997423989189752 -2.9481 0.7070619014584908 0.7070606099107002 3.0094775360992032e-09 -0.09997424771633134 -2.9482000000000004 0.7070619157800571 0.707060623246063 2.8312867874843994e-09 -0.09997425553838887 -2.9483 0.7070619300953779 0.7070606365792713 2.642552864896841e-09 -0.0999742633580708 -2.9484 0.7070619444043419 0.7070606499104388 2.4433225156647587e-09 -0.09997427117537787 -2.9485 0.7070619587068383 0.7070606632396791 2.2336448949125676e-09 -0.0999742789903108 -2.9486000000000003 0.7070619730027567 0.707060676567105 2.0135715534178034e-09 -0.09997428680287035 -2.9487 0.7070619872919874 0.7070606898928287 1.7831564254680576e-09 -0.09997429461305715 -2.9488000000000003 0.7070620015744213 0.7070607032169616 1.5424558115137432e-09 -0.09997430242087192 -2.9489 0.70706201584995 0.7070607165396152 1.2915283738312855e-09 -0.0999743102263155 -2.949 0.7070620301184656 0.7070607298608997 1.0304351157064406e-09 -0.0999743180293885 -2.9491000000000005 0.7070620443798605 0.7070607431809248 7.592393614849757e-10 -0.09997432583009168 -2.9492000000000003 0.7070620586340288 0.7070607564997996 4.780067548379452e-10 -0.09997433362842573 -2.9493 0.7070620728808648 0.7070607698176323 1.8680523360820045e-10 -0.09997434142439143 -2.9494000000000002 0.7070620871202634 0.7070607831345304 -1.1429499274101529e-10 -0.09997434921798948 -2.9495 0.7070621013521206 0.7070607964506004 -4.252214405239818e-10 -0.09997435700922057 -2.9496 0.7070621155763326 0.7070608097659483 -7.458993882616949e-10 -0.09997436479808541 -2.9497000000000004 0.7070621297927974 0.7070608230806794 -1.0762518862228454e-09 -0.0999743725845848 -2.9498 0.7070621440014132 0.7070608363948978 -1.4161997729036924e-09 -0.0999743803687194 -2.9499 0.707062158202079 0.707060849708707 -1.7656616975794681e-09 -0.09997438815048994 -2.95 0.7070621723946948 0.7070608630222088 -2.1245541437231452e-09 -0.0999743959298971 -2.9501000000000004 0.7070621865791624 0.7070608763355054 -2.492791436811692e-09 -0.09997440370694168 -2.9502 0.7070622007553828 0.7070608896486972 -2.8702857798879045e-09 -0.09997441148162431 -2.9503000000000004 0.7070622149232594 0.7070609029618833 -3.256947257029852e-09 -0.09997441925394572 -2.9504 0.7070622290826961 0.7070609162751627 -3.652683873249518e-09 -0.09997442702390663 -2.9505 0.7070622432335979 0.7070609295886332 -4.05740156403378e-09 -0.09997443479150782 -2.9506000000000006 0.7070622573758707 0.7070609429023911 -4.471004220497898e-09 -0.09997444255674995 -2.9507000000000003 0.7070622715094216 0.7070609562165318 -4.8933937136716454e-09 -0.09997445031963376 -2.9508 0.7070622856341584 0.7070609695311498 -5.3244699205201584e-09 -0.09997445808015988 -2.9509000000000003 0.7070622997499907 0.7070609828463388 -5.764130736954365e-09 -0.09997446583832915 -2.951 0.7070623138568286 0.7070609961621903 -6.212272115994899e-09 -0.09997447359414223 -2.9511000000000003 0.7070623279545839 0.7070610094787957 -6.66878808164989e-09 -0.09997448134759984 -2.9512000000000005 0.7070623420431689 0.7070610227962448 -7.133570757537899e-09 -0.09997448909870263 -2.9513000000000003 0.7070623561224978 0.7070610361146266 -7.606510393776134e-09 -0.09997449684745147 -2.9514 0.7070623701924854 0.7070610494340284 -8.087495394736022e-09 -0.09997450459384699 -2.9515 0.707062384253048 0.7070610627545365 -8.576412336390449e-09 -0.0999745123378899 -2.9516000000000004 0.7070623983041029 0.7070610760762357 -9.073146000140864e-09 -0.09997452007958088 -2.9517 0.7070624123455691 0.7070610893992102 -9.577579401440217e-09 -0.09997452781892072 -2.9518 0.7070624263773664 0.7070611027235423 -1.0089593815813813e-08 -0.09997453555591006 -2.9519 0.7070624403994161 0.707061116049313 -1.0609068803145438e-08 -0.09997454329054961 -2.952 0.7070624544116411 0.7070611293766025 -1.113588223673398e-08 -0.09997455102284014 -2.9521 0.7070624684139651 0.7070611427054891 -1.166991033625317e-08 -0.09997455875278236 -2.9522000000000004 0.7070624824063136 0.70706115603605 -1.221102769290508e-08 -0.09997456648037692 -2.9523 0.7070624963886132 0.7070611693683615 -1.2759107303680906e-08 -0.09997457420562461 -2.9524 0.7070625103607919 0.7070611827024975 -1.3314020593478693e-08 -0.09997458192852607 -2.9525 0.7070625243227795 0.7070611960385312 -1.3875637452399892e-08 -0.09997458964908208 -2.9526000000000003 0.7070625382745066 0.7070612093765344 -1.4443826260035486e-08 -0.09997459736729332 -2.9527 0.7070625522159055 0.7070612227165772 -1.501845392362991e-08 -0.09997460508316051 -2.9528000000000003 0.7070625661469099 0.7070612360587283 -1.5599385901499813e-08 -0.09997461279668433 -2.9529 0.7070625800674555 0.7070612494030553 -1.6186486241197978e-08 -0.0999746205078656 -2.953 0.7070625939774785 0.7070612627496238 -1.677961760770258e-08 -0.09997462821670493 -2.9531000000000005 0.7070626078769173 0.707061276098498 -1.737864131377484e-08 -0.09997463592320305 -2.9532000000000003 0.7070626217657114 0.7070612894497408 -1.7983417357255588e-08 -0.09997464362736064 -2.9533 0.7070626356438023 0.7070613028034136 -1.8593804448820833e-08 -0.09997465132917849 -2.9534000000000002 0.7070626495111327 0.7070613161595761 -1.920966004841096e-08 -0.09997465902865726 -2.9535 0.7070626633676467 0.7070613295182864 -1.9830840397756788e-08 -0.09997466672579763 -2.9536000000000002 0.70706267721329 0.7070613428796011 -2.0457200556808774e-08 -0.09997467442060032 -2.9537000000000004 0.7070626910480106 0.7070613562435755 -2.108859442715577e-08 -0.0999746821130661 -2.9538 0.7070627048717572 0.707061369610263 -2.1724874799729926e-08 -0.09997468980319565 -2.9539 0.7070627186844802 0.7070613829797153 -2.2365893379960172e-08 -0.09997469749098963 -2.954 0.707062732486132 0.707061396351983 -2.3011500826369824e-08 -0.0999747051764488 -2.9541000000000004 0.7070627462766668 0.707061409727115 -2.36615467818016e-08 -0.09997471285957389 -2.9542 0.7070627600560395 0.707061423105158 -2.4315879911581545e-08 -0.0999747205403656 -2.9543000000000004 0.7070627738242075 0.7070614364861572 -2.4974347938647168e-08 -0.09997472821882458 -2.9544 0.7070627875811291 0.7070614498701566 -2.5636797678675605e-08 -0.09997473589495154 -2.9545 0.7070628013267655 0.7070614632571987 -2.6303075071742316e-08 -0.09997474356874732 -2.9546000000000006 0.7070628150610783 0.7070614766473236 -2.697302522438813e-08 -0.09997475124021254 -2.9547000000000003 0.707062828784031 0.7070614900405698 -2.7646492442362156e-08 -0.09997475890934787 -2.9548 0.707062842495589 0.7070615034369747 -2.8323320267484645e-08 -0.09997476657615399 -2.9549000000000003 0.70706285619572 0.7070615168365736 -2.900335151190779e-08 -0.09997477424063168 -2.955 0.7070628698843923 0.7070615302394003 -2.9686428297363843e-08 -0.09997478190278167 -2.9551000000000003 0.7070628835615766 0.7070615436454866 -3.03723920905101e-08 -0.09997478956260461 -2.9552000000000005 0.707062897227245 0.7070615570548628 -3.1061083741743337e-08 -0.09997479722010122 -2.9553000000000003 0.7070629108813717 0.7070615704675578 -3.1752343518810094e-08 -0.09997480487527223 -2.9554 0.7070629245239319 0.7070615838835981 -3.2446011145187414e-08 -0.0999748125281183 -2.9555 0.7070629381549032 0.707061597303009 -3.3141925838029926e-08 -0.09997482017864012 -2.9556000000000004 0.7070629517742648 0.7070616107258137 -3.383992634503272e-08 -0.09997482782683847 -2.9557 0.7070629653819975 0.7070616241520342 -3.453985097999317e-08 -0.09997483547271407 -2.9558 0.707062978978084 0.70706163758169 -3.5241537663360106e-08 -0.09997484311626754 -2.9559 0.7070629925625083 0.7070616510147992 -3.594482395844617e-08 -0.0999748507574996 -2.956 0.7070630061352565 0.7070616644513785 -3.664954710839909e-08 -0.09997485839641093 -2.9561 0.7070630196963172 0.7070616778914427 -3.73555440726309e-08 -0.0999748660330024 -2.9562000000000004 0.7070630332456793 0.7070616913350047 -3.806265156931863e-08 -0.09997487366727462 -2.9563 0.7070630467833343 0.7070617047820752 -3.877070610706305e-08 -0.09997488129922823 -2.9564 0.7070630603092752 0.7070617182326636 -3.947954402690147e-08 -0.09997488892886394 -2.9565 0.7070630738234971 0.7070617316867781 -4.0189001538357486e-08 -0.09997489655618257 -2.9566000000000003 0.7070630873259964 0.7070617451444241 -4.0898914757821724e-08 -0.09997490418118471 -2.9567 0.7070631008167716 0.7070617586056056 -4.16091197469326e-08 -0.09997491180387108 -2.9568000000000003 0.7070631142958228 0.7070617720703252 -4.2319452548924196e-08 -0.09997491942424239 -2.9569 0.7070631277631518 0.7070617855385838 -4.302974922815899e-08 -0.09997492704229943 -2.957 0.7070631412187627 0.7070617990103794 -4.373984590555415e-08 -0.09997493465804275 -2.9571000000000005 0.7070631546626603 0.7070618124857095 -4.4449578799361095e-08 -0.09997494227147315 -2.9572000000000003 0.7070631680948523 0.7070618259645693 -4.515878426107969e-08 -0.09997494988259129 -2.9573 0.7070631815153474 0.7070618394469526 -4.586729881306652e-08 -0.0999749574913979 -2.9574000000000003 0.7070631949241564 0.707061852932851 -4.657495918748483e-08 -0.09997496509789368 -2.9575 0.7070632083212915 0.7070618664222543 -4.728160236309965e-08 -0.09997497270207929 -2.9576000000000002 0.7070632217067672 0.7070618799151509 -4.798706560252015e-08 -0.09997498030395546 -2.9577000000000004 0.7070632350805994 0.707061893411528 -4.869118648987564e-08 -0.099974987903523 -2.9578 0.7070632484428059 0.7070619069113699 -4.9393802968003726e-08 -0.09997499550078254 -2.9579 0.7070632617934058 0.7070619204146595 -5.0094753376288964e-08 -0.09997500309573468 -2.958 0.7070632751324203 0.7070619339213782 -5.079387648823045e-08 -0.09997501068838019 -2.9581000000000004 0.7070632884598722 0.7070619474315057 -5.149101154852155e-08 -0.09997501827871977 -2.9582 0.7070633017757864 0.7070619609450199 -5.218599830720226e-08 -0.09997502586675414 -2.9583000000000004 0.707063315080189 0.707061974461897 -5.287867706053363e-08 -0.09997503345248399 -2.9584 0.7070633283731078 0.7070619879821112 -5.356888868515014e-08 -0.09997504103590994 -2.9585 0.7070633416545729 0.7070620015056357 -5.425647467438045e-08 -0.09997504861703281 -2.9586000000000006 0.7070633549246155 0.7070620150324411 -5.4941277177495557e-08 -0.09997505619585326 -2.9587000000000003 0.7070633681832688 0.7070620285624971 -5.562313903158429e-08 -0.09997506377237192 -2.9588 0.7070633814305672 0.7070620420957712 -5.630190380058464e-08 -0.09997507134658958 -2.9589000000000003 0.7070633946665477 0.7070620556322296 -5.697741581236343e-08 -0.09997507891850689 -2.959 0.7070634078912481 0.7070620691718368 -5.7649520189074e-08 -0.09997508648812463 -2.9591000000000003 0.7070634211047082 0.7070620827145553 -5.8318062890090616e-08 -0.09997509405544337 -2.9592 0.7070634343069693 0.7070620962603461 -5.898289074171559e-08 -0.09997510162046389 -2.9593000000000003 0.7070634474980746 0.7070621098091688 -5.96438514720906e-08 -0.09997510918318687 -2.9594 0.707063460678069 0.7070621233609813 -6.03007937497943e-08 -0.09997511674361306 -2.9595 0.7070634738469983 0.7070621369157395 -6.095356721571785e-08 -0.0999751243017431 -2.9596000000000005 0.7070634870049105 0.707062150473398 -6.160202251862673e-08 -0.09997513185757764 -2.9597 0.7070635001518552 0.7070621640339101 -6.224601135050578e-08 -0.09997513941111746 -2.9598 0.7070635132878833 0.707062177597227 -6.288538647669997e-08 -0.09997514696236326 -2.9599 0.7070635264130474 0.7070621911632986 -6.352000177190995e-08 -0.09997515451131563 -2.96 0.7070635395274019 0.7070622047320732 -6.414971225532015e-08 -0.09997516205797535 -2.9601 0.7070635526310021 0.7070622183034975 -6.477437412008916e-08 -0.09997516960234314 -2.9602000000000004 0.7070635657239055 0.7070622318775167 -6.539384476847779e-08 -0.09997517714441963 -2.9603 0.707063578806171 0.7070622454540747 -6.600798284480888e-08 -0.09997518468420555 -2.9604 0.7070635918778583 0.7070622590331134 -6.66166482623555e-08 -0.09997519222170155 -2.9605 0.70706360493903 0.7070622726145737 -6.721970224714269e-08 -0.09997519975690843 -2.9606000000000003 0.7070636179897487 0.7070622861983948 -6.781700735486104e-08 -0.0999752072898268 -2.9607 0.7070636310300793 0.7070622997845146 -6.840842751293374e-08 -0.09997521482045738 -2.9608000000000003 0.7070636440600875 0.7070623133728694 -6.899382804783846e-08 -0.09997522234880084 -2.9609 0.7070636570798415 0.7070623269633939 -6.957307571459764e-08 -0.09997522987485788 -2.961 0.7070636700894101 0.7070623405560219 -7.014603872973826e-08 -0.09997523739862929 -2.9611000000000005 0.7070636830888635 0.7070623541506855 -7.071258679818004e-08 -0.09997524492011567 -2.9612000000000003 0.7070636960782732 0.707062367747315 -7.127259114706255e-08 -0.09997525243931771 -2.9613 0.7070637090577128 0.7070623813458399 -7.182592455046502e-08 -0.09997525995623607 -2.9614000000000003 0.7070637220272565 0.7070623949461885 -7.237246136236608e-08 -0.09997526747087158 -2.9615 0.7070637349869802 0.7070624085482871 -7.291207753962886e-08 -0.09997527498322481 -2.9616000000000002 0.7070637479369606 0.7070624221520612 -7.344465067756281e-08 -0.09997528249329644 -2.9617000000000004 0.7070637608772765 0.7070624357574347 -7.39700600303067e-08 -0.09997529000108724 -2.9618 0.7070637738080077 0.7070624493643309 -7.448818654292103e-08 -0.09997529750659792 -2.9619 0.7070637867292349 0.707062462972671 -7.499891287610777e-08 -0.09997530500982912 -2.962 0.7070637996410398 0.7070624765823749 -7.550212343656812e-08 -0.0999753125107815 -2.9621000000000004 0.7070638125435065 0.707062490193362 -7.599770439695175e-08 -0.09997532000945576 -2.9622 0.7070638254367192 0.7070625038055505 -7.648554372925026e-08 -0.0999753275058527 -2.9623000000000004 0.7070638383207639 0.7070625174188567 -7.696553121737393e-08 -0.09997533499997291 -2.9624 0.7070638511957272 0.7070625310331963 -7.743755849748402e-08 -0.09997534249181708 -2.9625 0.7070638640616973 0.7070625446484833 -7.790151907664106e-08 -0.09997534998138591 -2.9626000000000006 0.7070638769187636 0.7070625582646317 -7.835730835101945e-08 -0.09997535746868019 -2.9627000000000003 0.7070638897670163 0.7070625718815534 -7.880482363366303e-08 -0.09997536495370057 -2.9628 0.7070639026065466 0.7070625854991592 -7.924396417790386e-08 -0.09997537243644765 -2.9629000000000003 0.7070639154374468 0.7070625991173591 -7.967463120511775e-08 -0.09997537991692215 -2.963 0.7070639282598106 0.7070626127360622 -8.009672791426531e-08 -0.09997538739512478 -2.9631000000000003 0.7070639410737323 0.7070626263551765 -8.051015952265789e-08 -0.09997539487105622 -2.9632 0.7070639538793075 0.7070626399746089 -8.091483325901871e-08 -0.09997540234471719 -2.9633000000000003 0.7070639666766323 0.7070626535942657 -8.131065841639196e-08 -0.09997540981610831 -2.9634 0.7070639794658045 0.7070626672140518 -8.169754635040799e-08 -0.09997541728523036 -2.9635 0.7070639922469224 0.7070626808338711 -8.207541050703898e-08 -0.09997542475208399 -2.9636000000000005 0.7070640050200849 0.7070626944536269 -8.244416643387459e-08 -0.09997543221666988 -2.9637000000000002 0.7070640177853924 0.7070627080732218 -8.280373181568379e-08 -0.0999754396789887 -2.9638 0.7070640305429456 0.7070627216925571 -8.31540264787517e-08 -0.09997544713904118 -2.9639 0.7070640432928464 0.7070627353115337 -8.349497241082887e-08 -0.09997545459682804 -2.964 0.7070640560351973 0.7070627489300512 -8.382649378368273e-08 -0.09997546205234985 -2.9641 0.7070640687701016 0.7070627625480084 -8.414851696437325e-08 -0.09997546950560733 -2.9642000000000004 0.7070640814976636 0.7070627761653041 -8.446097053780438e-08 -0.09997547695660125 -2.9643 0.7070640942179884 0.7070627897818358 -8.476378531019346e-08 -0.0999754844053323 -2.9644 0.7070641069311812 0.7070628033975002 -8.505689433942892e-08 -0.0999754918518011 -2.9645 0.7070641196373484 0.7070628170121933 -8.534023294374388e-08 -0.09997549929600835 -2.9646000000000003 0.7070641323365969 0.7070628306258108 -8.561373871212447e-08 -0.09997550673795472 -2.9647 0.7070641450290345 0.7070628442382475 -8.587735152339182e-08 -0.09997551417764096 -2.9648000000000003 0.7070641577147694 0.7070628578493975 -8.61310135566104e-08 -0.0999755216150677 -2.9649 0.7070641703939101 0.7070628714591545 -8.637466930323107e-08 -0.09997552905023564 -2.965 0.707064183066566 0.7070628850674114 -8.660826558270357e-08 -0.09997553648314544 -2.9651000000000005 0.7070641957328476 0.7070628986740612 -8.68317515511502e-08 -0.0999755439137979 -2.9652000000000003 0.7070642083928647 0.7070629122789955 -8.7045078709172e-08 -0.09997555134219357 -2.9653 0.7070642210467282 0.7070629258821057 -8.724820092093077e-08 -0.09997555876833317 -2.9654000000000003 0.7070642336945496 0.707062939483283 -8.744107441588378e-08 -0.09997556619221735 -2.9655 0.707064246336441 0.7070629530824181 -8.762365780699832e-08 -0.0999755736138469 -2.9656000000000002 0.7070642589725145 0.707062966679401 -8.779591208641496e-08 -0.09997558103322245 -2.9657000000000004 0.7070642716028823 0.7070629802741216 -8.795780064279474e-08 -0.09997558845034464 -2.9658 0.7070642842276578 0.7070629938664692 -8.810928927259487e-08 -0.09997559586521415 -2.9659 0.7070642968469545 0.7070630074563333 -8.825034617833405e-08 -0.09997560327783181 -2.966 0.7070643094608857 0.7070630210436024 -8.838094198160285e-08 -0.0999756106881982 -2.9661000000000004 0.7070643220695657 0.707063034628165 -8.850104972653317e-08 -0.09997561809631401 -2.9662 0.7070643346731083 0.7070630482099092 -8.861064488153297e-08 -0.09997562550217991 -2.9663000000000004 0.707064347271628 0.7070630617887232 -8.8709705350562e-08 -0.09997563290579661 -2.9664 0.7070643598652395 0.7070630753644948 -8.879821147833589e-08 -0.09997564030716477 -2.9665 0.7070643724540576 0.7070630889371112 -8.887614604685679e-08 -0.09997564770628509 -2.9666000000000006 0.707064385038197 0.7070631025064602 -8.894349428061749e-08 -0.09997565510315817 -2.9667000000000003 0.7070643976177733 0.7070631160724292 -8.900024385614241e-08 -0.09997566249778482 -2.9668 0.7070644101929012 0.7070631296349055 -8.90463848959161e-08 -0.09997566989016567 -2.9669 0.7070644227636962 0.707063143193776 -8.908190997705678e-08 -0.09997567728030138 -2.967 0.7070644353302733 0.7070631567489276 -8.910681412437754e-08 -0.09997568466819261 -2.9671000000000003 0.707064447892748 0.7070631703002479 -8.912109481472308e-08 -0.09997569205384008 -2.9672 0.707064460451236 0.7070631838476239 -8.912475197783709e-08 -0.09997569943724453 -2.9673000000000003 0.7070644730058524 0.7070631973909425 -8.911778799722964e-08 -0.09997570681840659 -2.9674 0.7070644855567123 0.7070632109300907 -8.910020770237087e-08 -0.0999757141973269 -2.9675 0.7070644981039307 0.707063224464956 -8.907201837302786e-08 -0.09997572157400614 -2.9676000000000005 0.707064510647623 0.7070632379954258 -8.903322973492778e-08 -0.09997572894844509 -2.9677000000000002 0.7070645231879042 0.7070632515213875 -8.898385395195163e-08 -0.09997573632064437 -2.9678 0.7070645357248887 0.7070632650427289 -8.892390563654262e-08 -0.09997574369060463 -2.9679 0.7070645482586913 0.7070632785593376 -8.885340182715473e-08 -0.09997575105832661 -2.968 0.7070645607894261 0.7070632920711019 -8.877236199866106e-08 -0.09997575842381096 -2.9681 0.7070645733172076 0.7070633055779098 -8.868080804674133e-08 -0.09997576578705836 -2.9682000000000004 0.7070645858421492 0.7070633190796498 -8.857876428614714e-08 -0.09997577314806941 -2.9683 0.7070645983643645 0.707063332576211 -8.846625745070197e-08 -0.09997578050684489 -2.9684 0.7070646108839671 0.7070633460674827 -8.834331667335188e-08 -0.09997578786338546 -2.9685 0.7070646234010698 0.7070633595533542 -8.82099734905023e-08 -0.09997579521769183 -2.9686000000000003 0.707064635915785 0.7070633730337152 -8.806626182380345e-08 -0.09997580256976459 -2.9687 0.7070646484282247 0.7070633865084562 -8.791221798361976e-08 -0.09997580991960447 -2.9688000000000003 0.707064660938501 0.707063399977468 -8.774788064908057e-08 -0.09997581726721216 -2.9689 0.7070646734467247 0.7070634134406414 -8.757329086374332e-08 -0.09997582461258832 -2.969 0.707064685953007 0.7070634268978682 -8.73884920234505e-08 -0.09997583195573362 -2.9691000000000005 0.7070646984574578 0.7070634403490402 -8.719352986505391e-08 -0.09997583929664872 -2.9692000000000003 0.7070647109601873 0.7070634537940504 -8.698845246381259e-08 -0.09997584663533436 -2.9693 0.7070647234613048 0.7070634672327922 -8.677331020303519e-08 -0.0999758539717912 -2.9694000000000003 0.7070647359609183 0.707063480665159 -8.65481557792841e-08 -0.09997586130601993 -2.9695 0.7070647484591364 0.7070634940910449 -8.631304418416086e-08 -0.09997586863802115 -2.9696000000000002 0.7070647609560666 0.7070635075103447 -8.606803269303048e-08 -0.09997587596779556 -2.9697000000000005 0.7070647734518155 0.7070635209229549 -8.58131808407353e-08 -0.09997588329534393 -2.9698 0.7070647859464891 0.707063534328771 -8.554855042072762e-08 -0.09997589062066685 -2.9699 0.707064798440193 0.7070635477276899 -8.527420545991621e-08 -0.09997589794376495 -2.97 0.707064810933032 0.7070635611196097 -8.499021220565589e-08 -0.099975905264639 -2.9701000000000004 0.7070648234251102 0.7070635745044282 -8.469663911620656e-08 -0.09997591258328964 -2.9702 0.7070648359165308 0.7070635878820453 -8.439355683818178e-08 -0.09997591989971755 -2.9703000000000004 0.7070648484073958 0.7070636012523603 -8.408103819093626e-08 -0.0999759272139234 -2.9704 0.7070648608978071 0.7070636146152743 -8.375915814401447e-08 -0.09997593452590782 -2.9705 0.7070648733878655 0.707063627970689 -8.342799381021171e-08 -0.09997594183567154 -2.9706000000000006 0.7070648858776711 0.7070636413185065 -8.308762442389012e-08 -0.09997594914321528 -2.9707000000000003 0.7070648983673231 0.7070636546586302 -8.273813130801888e-08 -0.09997595644853963 -2.9708 0.707064910856919 0.7070636679909643 -8.237959787677634e-08 -0.09997596375164523 -2.9709 0.7070649233465567 0.7070636813154143 -8.201210959825345e-08 -0.09997597105253289 -2.971 0.7070649358363323 0.7070636946318859 -8.163575398404538e-08 -0.09997597835120321 -2.9711000000000003 0.7070649483263411 0.7070637079402864 -8.125062056323074e-08 -0.09997598564765689 -2.9712 0.7070649608166775 0.7070637212405235 -8.085680087022845e-08 -0.09997599294189452 -2.9713000000000003 0.7070649733074345 0.7070637345325066 -8.045438840576652e-08 -0.09997600023391685 -2.9714 0.7070649857987049 0.7070637478161457 -8.00434786299431e-08 -0.09997600752372456 -2.9715 0.7070649982905797 0.7070637610913515 -7.962416893273622e-08 -0.09997601481131824 -2.9716000000000005 0.7070650107831491 0.7070637743580366 -7.919655861318708e-08 -0.09997602209669865 -2.9717000000000002 0.7070650232765021 0.7070637876161141 -7.87607488568487e-08 -0.09997602937986638 -2.9718 0.7070650357707271 0.7070638008654986 -7.831684271149969e-08 -0.09997603666082218 -2.9719 0.7070650482659104 0.7070638141061054 -7.78649450567867e-08 -0.09997604393956669 -2.972 0.707065060762138 0.7070638273378512 -7.740516259034658e-08 -0.09997605121610055 -2.9721 0.7070650732594945 0.7070638405606536 -7.693760379137715e-08 -0.09997605849042442 -2.9722000000000004 0.7070650857580634 0.7070638537744323 -7.646237890329005e-08 -0.0999760657625391 -2.9723 0.7070650982579265 0.7070638669791072 -7.59795999059551e-08 -0.09997607303244517 -2.9724 0.707065110759165 0.7070638801745993 -7.548938048534265e-08 -0.09997608030014331 -2.9725 0.7070651232618581 0.7070638933608318 -7.499183601010484e-08 -0.09997608756563414 -2.9726000000000004 0.7070651357660848 0.7070639065377285 -7.44870835059884e-08 -0.0999760948289184 -2.9727 0.7070651482719221 0.7070639197052151 -7.397524162591068e-08 -0.09997610208999679 -2.9728000000000003 0.7070651607794458 0.7070639328632171 -7.345643062090304e-08 -0.09997610934886991 -2.9729 0.7070651732887303 0.7070639460116632 -7.293077231539102e-08 -0.09997611660553843 -2.973 0.7070651857998488 0.707063959150482 -7.239839007727039e-08 -0.099976123860003 -2.9731000000000005 0.7070651983128733 0.7070639722796045 -7.185940878451369e-08 -0.09997613111226439 -2.9732000000000003 0.7070652108278743 0.7070639853989622 -7.131395480435357e-08 -0.09997613836232316 -2.9733 0.7070652233449208 0.7070639985084884 -7.076215595685359e-08 -0.09997614561018003 -2.9734000000000003 0.7070652358640807 0.7070640116081177 -7.020414148498424e-08 -0.09997615285583564 -2.9735 0.7070652483854203 0.7070640246977864 -6.964004203380628e-08 -0.09997616009929072 -2.9736000000000002 0.7070652609090045 0.7070640377774318 -6.906998960536787e-08 -0.09997616734054587 -2.9737000000000005 0.7070652734348966 0.7070640508469925 -6.849411754005635e-08 -0.09997617457960178 -2.9738 0.7070652859631588 0.7070640639064093 -6.791256047583225e-08 -0.09997618181645915 -2.9739 0.7070652984938517 0.7070640769556238 -6.732545432827988e-08 -0.09997618905111862 -2.974 0.7070653110270342 0.7070640899945793 -6.67329362442036e-08 -0.09997619628358084 -2.9741000000000004 0.7070653235627637 0.7070641030232204 -6.613514458297942e-08 -0.09997620351384648 -2.9742 0.7070653361010969 0.7070641160414934 -6.553221887622279e-08 -0.0999762107419162 -2.9743000000000004 0.707065348642088 0.7070641290493462 -6.492429980003295e-08 -0.09997621796779071 -2.9744 0.7070653611857902 0.7070641420467285 -6.431152913769639e-08 -0.09997622519147074 -2.9745 0.707065373732255 0.7070641550335905 -6.369404974976289e-08 -0.09997623241295682 -2.9746000000000006 0.7070653862815324 0.7070641680098848 -6.307200554108577e-08 -0.09997623963224965 -2.9747000000000003 0.7070653988336705 0.7070641809755652 -6.244554142482636e-08 -0.09997624684934991 -2.9748 0.7070654113887165 0.7070641939305875 -6.181480328992794e-08 -0.09997625406425831 -2.9749 0.7070654239467158 0.7070642068749087 -6.117993796598761e-08 -0.09997626127697547 -2.975 0.7070654365077114 0.7070642198084871 -6.054109319506701e-08 -0.09997626848750202 -2.9751000000000003 0.7070654490717458 0.7070642327312835 -5.989841758658951e-08 -0.09997627569583865 -2.9752 0.7070654616388596 0.7070642456432596 -5.925206059262042e-08 -0.09997628290198608 -2.9753000000000003 0.7070654742090916 0.7070642585443787 -5.860217246840202e-08 -0.09997629010594494 -2.9754 0.7070654867824788 0.7070642714346063 -5.794890423744224e-08 -0.09997629730771589 -2.9755 0.707065499359057 0.7070642843139088 -5.7292407657904415e-08 -0.09997630450729955 -2.9756000000000005 0.7070655119388602 0.7070642971822547 -5.663283518747911e-08 -0.09997631170469666 -2.9757000000000002 0.7070655245219206 0.7070643100396141 -5.5970339945653896e-08 -0.09997631889990785 -2.9758 0.7070655371082688 0.7070643228859586 -5.53050756822715e-08 -0.09997632609293378 -2.9759 0.7070655496979339 0.7070643357212616 -5.4637196737414295e-08 -0.0999763332837751 -2.976 0.7070655622909432 0.7070643485454984 -5.396685800736038e-08 -0.09997634047243253 -2.9761 0.7070655748873224 0.7070643613586453 -5.32942149098891e-08 -0.0999763476589067 -2.9762000000000004 0.7070655874870955 0.7070643741606808 -5.2619423348068683e-08 -0.09997635484319828 -2.9763 0.7070656000902846 0.7070643869515847 -5.194263967165866e-08 -0.09997636202530791 -2.9764 0.7070656126969107 0.7070643997313388 -5.126402064263222e-08 -0.09997636920523623 -2.9765 0.7070656253069925 0.7070644124999269 -5.058372340243332e-08 -0.09997637638298398 -2.9766000000000004 0.7070656379205473 0.7070644252573337 -4.9901905426765446e-08 -0.09997638355855178 -2.9767 0.7070656505375905 0.7070644380035462 -4.9218724498052875e-08 -0.09997639073194027 -2.9768000000000003 0.707065663158136 0.7070644507385526 -4.853433866348206e-08 -0.09997639790315013 -2.9769 0.7070656757821963 0.7070644634623436 -4.7848906201716605e-08 -0.09997640507218204 -2.977 0.7070656884097812 0.7070644761749107 -4.7162585582998656e-08 -0.09997641223903665 -2.9771000000000005 0.7070657010408998 0.7070644888762476 -4.6475535436189125e-08 -0.0999764194037146 -2.9772000000000003 0.7070657136755591 0.7070645015663495 -4.5787914509140114e-08 -0.09997642656621654 -2.9773 0.7070657263137647 0.7070645142452133 -4.509988163465097e-08 -0.09997643372654318 -2.9774000000000003 0.7070657389555199 0.7070645269128382 -4.441159569067805e-08 -0.09997644088469516 -2.9775 0.7070657516008266 0.7070645395692243 -4.372321556561317e-08 -0.09997644804067314 -2.9776000000000002 0.7070657642496849 0.7070645522143738 -4.303490012247781e-08 -0.09997645519447776 -2.9777000000000005 0.7070657769020936 0.7070645648482905 -4.234680816084729e-08 -0.09997646234610968 -2.9778000000000002 0.7070657895580497 0.7070645774709801 -4.1659098379601654e-08 -0.09997646949556968 -2.9779 0.7070658022175478 0.7070645900824495 -4.0971929341838183e-08 -0.09997647664285826 -2.978 0.7070658148805813 0.7070646026827079 -4.028545943796785e-08 -0.09997648378797613 -2.9781000000000004 0.7070658275471419 0.7070646152717659 -3.9599846848262926e-08 -0.09997649093092395 -2.9782 0.7070658402172199 0.707064627849636 -3.891524950872492e-08 -0.09997649807170242 -2.9783000000000004 0.7070658528908034 0.707064640416332 -3.823182507145702e-08 -0.09997650521031214 -2.9784 0.7070658655678789 0.7070646529718696 -3.754973087013221e-08 -0.09997651234675377 -2.9785 0.7070658782484314 0.7070646655162665 -3.686912388573254e-08 -0.09997651948102802 -2.9786000000000006 0.7070658909324443 0.7070646780495415 -3.619016070567464e-08 -0.09997652661313555 -2.9787000000000003 0.7070659036198992 0.7070646905717155 -3.5512997493126856e-08 -0.09997653374307695 -2.9788 0.7070659163107755 0.7070647030828107 -3.48377899462432e-08 -0.09997654087085289 -2.9789 0.7070659290050518 0.7070647155828513 -3.416469326628785e-08 -0.09997654799646408 -2.979 0.7070659417027048 0.7070647280718634 -3.349386212001329e-08 -0.09997655511991112 -2.9791000000000003 0.7070659544037091 0.7070647405498742 -3.282545060377326e-08 -0.09997656224119475 -2.9792 0.7070659671080382 0.7070647530169127 -3.21596122095872e-08 -0.09997656936031556 -2.9793000000000003 0.7070659798156633 0.7070647654730096 -3.149649978957843e-08 -0.09997657647727419 -2.9794 0.7070659925265548 0.7070647779181971 -3.083626551976179e-08 -0.09997658359207129 -2.9795 0.7070660052406809 0.7070647903525097 -3.017906086599971e-08 -0.0999765907047076 -2.9796000000000005 0.7070660179580086 0.7070648027759825 -2.9525036549524555e-08 -0.09997659781518378 -2.9797000000000002 0.7070660306785026 0.7070648151886529 -2.8874342510943132e-08 -0.09997660492350038 -2.9798 0.7070660434021265 0.7070648275905596 -2.8227127877276936e-08 -0.09997661202965813 -2.9799 0.7070660561288425 0.707064839981743 -2.7583540929002406e-08 -0.09997661913365766 -2.98 0.7070660688586111 0.707064852362245 -2.694372906210385e-08 -0.09997662623549967 -2.9801 0.7070660815913907 0.7070648647321092 -2.630783875814946e-08 -0.09997663333518475 -2.9802000000000004 0.7070660943271383 0.7070648770913806 -2.5676015550247372e-08 -0.09997664043271354 -2.9803 0.7070661070658102 0.7070648894401059 -2.5048403986399626e-08 -0.09997664752808676 -2.9804 0.7070661198073602 0.7070649017783334 -2.442514760066239e-08 -0.09997665462130507 -2.9805 0.7070661325517411 0.7070649141061125 -2.380638887931885e-08 -0.09997666171236909 -2.9806000000000004 0.7070661452989038 0.7070649264234947 -2.3192269226618434e-08 -0.09997666880127946 -2.9807 0.7070661580487976 0.7070649387305328 -2.2582928934419128e-08 -0.09997667588803683 -2.9808000000000003 0.707066170801371 0.7070649510272807 -2.1978507147493026e-08 -0.0999766829726419 -2.9809 0.7070661835565704 0.7070649633137944 -2.1379141833602344e-08 -0.09997669005509527 -2.981 0.707066196314341 0.707064975590131 -2.0784969753141758e-08 -0.09997669713539764 -2.9811000000000005 0.7070662090746265 0.7070649878563493 -2.01961264274797e-08 -0.09997670421354965 -2.9812000000000003 0.7070662218373691 0.7070650001125093 -1.9612746106865975e-08 -0.09997671128955196 -2.9813 0.70706623460251 0.7070650123586726 -1.903496173833938e-08 -0.0999767183634053 -2.9814000000000003 0.707066247369988 0.7070650245949015 -1.846290493883948e-08 -0.09997672543511016 -2.9815 0.7070662601397413 0.707065036821261 -1.789670596311424e-08 -0.09997673250466727 -2.9816000000000003 0.7070662729117065 0.7070650490378163 -1.7336493675964432e-08 -0.09997673957207727 -2.9817000000000005 0.7070662856858193 0.7070650612446346 -1.6782395521018623e-08 -0.09997674663734087 -2.9818000000000002 0.7070662984620131 0.7070650734417845 -1.6234537492110235e-08 -0.09997675370045865 -2.9819 0.7070663112402205 0.7070650856293352 -1.5693044104220927e-08 -0.09997676076143126 -2.982 0.7070663240203726 0.7070650978073583 -1.5158038369628146e-08 -0.09997676782025934 -2.9821000000000004 0.7070663368023999 0.7070651099759262 -1.4629641761042256e-08 -0.09997677487694365 -2.9822 0.7070663495862306 0.7070651221351122 -1.4107974193825618e-08 -0.09997678193148472 -2.9823000000000004 0.7070663623717921 0.7070651342849914 -1.3593153993900209e-08 -0.09997678898388326 -2.9824 0.7070663751590107 0.7070651464256397 -1.3085297868257323e-08 -0.09997679603413988 -2.9825 0.7070663879478113 0.7070651585571348 -1.258452088544193e-08 -0.09997680308225526 -2.9826000000000006 0.7070664007381178 0.7070651706795554 -1.2090936439990846e-08 -0.09997681012823009 -2.9827000000000004 0.7070664135298523 0.7070651827929808 -1.1604656236820221e-08 -0.09997681717206497 -2.9828 0.7070664263229365 0.7070651948974924 -1.1125790263469965e-08 -0.09997682421376056 -2.9829 0.7070664391172901 0.707065206993172 -1.0654446760613445e-08 -0.09997683125331747 -2.983 0.7070664519128325 0.7070652190801034 -1.0190732200807129e-08 -0.09997683829073643 -2.9831000000000003 0.7070664647094814 0.7070652311583709 -9.734751262903407e-09 -0.09997684532601807 -2.9832 0.7070664775071537 0.7070652432280596 -9.286606810800235e-09 -0.099976852359163 -2.9833000000000003 0.7070664903057648 0.7070652552892562 -8.846399865251875e-09 -0.09997685939017184 -2.9834 0.7070665031052301 0.7070652673420489 -8.414229593460554e-09 -0.09997686641904538 -2.9835 0.7070665159054623 0.707065279386526 -7.990193269177825e-09 -0.09997687344578417 -2.9836000000000005 0.7070665287063747 0.7070652914227769 -7.57438626316359e-09 -0.09997688047038883 -2.9837000000000002 0.7070665415078781 0.7070653034508925 -7.166902020634691e-09 -0.09997688749286 -2.9838 0.7070665543098839 0.7070653154709646 -6.767832036111421e-09 -0.0999768945131984 -2.9839 0.7070665671123012 0.707065327483086 -6.377265834335566e-09 -0.09997690153140468 -2.984 0.7070665799150389 0.7070653394873502 -5.995290951188448e-09 -0.0999769085474794 -2.9841 0.7070665927180046 0.7070653514838513 -5.621992918078411e-09 -0.09997691556142323 -2.9842000000000004 0.7070666055211055 0.7070653634726849 -5.25745522984844e-09 -0.09997692257323683 -2.9843 0.7070666183242474 0.7070653754539477 -4.901759339571987e-09 -0.09997692958292093 -2.9844 0.7070666311273357 0.7070653874277363 -4.554984634266845e-09 -0.09997693659047607 -2.9845 0.7070666439302745 0.7070653993941489 -4.217208420149998e-09 -0.09997694359590294 -2.9846000000000004 0.7070666567329673 0.707065411353284 -3.888505903555661e-09 -0.09997695059920216 -2.9847 0.7070666695353174 0.7070654233052415 -3.5689501761901332e-09 -0.09997695760037444 -2.9848000000000003 0.7070666823372262 0.7070654352501217 -3.2586121908456667e-09 -0.09997696459942043 -2.9849 0.7070666951385954 0.7070654471880251 -2.957560756196298e-09 -0.0999769715963407 -2.985 0.7070667079393251 0.7070654591190539 -2.665862514246442e-09 -0.09997697859113588 -2.9851000000000005 0.7070667207393154 0.7070654710433102 -2.3835819325246366e-09 -0.09997698558380667 -2.9852000000000003 0.7070667335384657 0.7070654829608973 -2.1107812858689456e-09 -0.09997699257435375 -2.9853 0.7070667463366741 0.707065494871919 -1.8475206416818102e-09 -0.09997699956277771 -2.9854000000000003 0.7070667591338388 0.7070655067764795 -1.5938578460522601e-09 -0.09997700654907918 -2.9855 0.7070667719298571 0.7070655186746835 -1.3498485124802118e-09 -0.09997701353325883 -2.9856000000000003 0.7070667847246259 0.7070655305666371 -1.1155460140702123e-09 -0.09997702051531732 -2.9857000000000005 0.7070667975180412 0.7070655424524459 -8.910014679189282e-10 -0.09997702749525529 -2.9858000000000002 0.7070668103099991 0.7070655543322164 -6.762637195026344e-10 -0.09997703447307335 -2.9859 0.707066823100394 0.7070655662060559 -4.713793409424905e-10 -0.09997704144877215 -2.986 0.7070668358891214 0.707065578074072 -2.763926171267528e-10 -0.09997704842235235 -2.9861000000000004 0.7070668486760754 0.7070655899363725 -9.134552923090178e-11 -0.09997705539381462 -2.9862 0.7070668614611496 0.7070656017930659 8.372224094554959e-11 -0.09997706236315954 -2.9863000000000004 0.7070668742442378 0.7070656136442609 2.487733283262905e-10 -0.09997706933038777 -2.9864 0.7070668870252328 0.7070656254900667 4.0377268455821236e-10 -0.09997707629549996 -2.9865 0.7070668998040278 0.7070656373305932 5.486876040322608e-10 -0.09997708325849686 -2.9866 0.7070669125805151 0.70706564916595 6.834877082709245e-10 -0.099977090219379 -2.9867000000000004 0.7070669253545865 0.7070656609962471 8.081449650101935e-10 -0.09997709717814703 -2.9868 0.7070669381261341 0.7070656728215949 9.226336916690059e-10 -0.0999771041348016 -2.9869 0.7070669508950493 0.7070656846421044 1.026930558818695e-09 -0.09997711108934333 -2.987 0.7070669636612237 0.707065696457886 1.1210145936524363e-09 -0.09997711804177288 -2.9871000000000003 0.7070669764245484 0.707065708269051 1.2048671869241412e-09 -0.09997712499209091 -2.9872 0.7070669891849144 0.7070657200757107 1.2784721024894363e-09 -0.099977131940298 -2.9873000000000003 0.7070670019422125 0.7070657318779763 1.3418154608257904e-09 -0.09997713888639484 -2.9874 0.7070670146963336 0.7070657436759598 1.3948857659207281e-09 -0.09997714583038213 -2.9875 0.7070670274471684 0.7070657554697724 1.4376738879245954e-09 -0.09997715277226041 -2.9876000000000005 0.7070670401946073 0.7070657672595257 1.4701730787630707e-09 -0.09997715971203036 -2.9877000000000002 0.707067052938541 0.7070657790453316 1.4923789625961859e-09 -0.09997716664969257 -2.9878 0.70706706567886 0.7070657908273018 1.5042895366856879e-09 -0.09997717358524777 -2.9879000000000002 0.7070670784154549 0.7070658026055481 1.5059051818033797e-09 -0.09997718051869658 -2.988 0.7070670911482162 0.707065814380182 1.4972286483533326e-09 -0.09997718745003958 -2.9881 0.7070671038770342 0.7070658261513154 1.4782650641781414e-09 -0.09997719437927742 -2.9882000000000004 0.7070671166018001 0.7070658379190596 1.4490219276200311e-09 -0.09997720130641079 -2.9883 0.7070671293224048 0.7070658496835263 1.4095091049187713e-09 -0.09997720823144035 -2.9884 0.7070671420387391 0.7070658614448269 1.3597388328137616e-09 -0.09997721515436675 -2.9885 0.7070671547506939 0.707065873203072 1.299725706400967e-09 -0.09997722207519051 -2.9886000000000004 0.7070671674581608 0.7070658849583729 1.2294866843370889e-09 -0.09997722899391236 -2.9887 0.7070671801610311 0.7070658967108403 1.149041079298585e-09 -0.09997723591053292 -2.9888000000000003 0.7070671928591966 0.7070659084605846 1.058410546705968e-09 -0.09997724282505278 -2.9889 0.7070672055525493 0.7070659202077161 9.57619095132145e-10 -0.09997724973747263 -2.989 0.7070672182409814 0.7070659319523445 8.46693060281567e-10 -0.09997725664779304 -2.9891000000000005 0.707067230924386 0.7070659436945801 7.256611162659299e-10 -0.09997726355601477 -2.9892000000000003 0.7070672436026555 0.7070659554345318 5.945542591243025e-10 -0.09997727046213839 -2.9893 0.7070672562756832 0.7070659671723085 4.5340579554742355e-10 -0.09997727736616452 -2.9894000000000003 0.707067268943363 0.7070659789080189 3.0225134287770183e-10 -0.09997728426809377 -2.9895 0.707067281605589 0.7070659906417707 1.411288134967048e-10 -0.09997729116792678 -2.9896000000000003 0.7070672942622558 0.7070660023736722 -2.9921586042203074e-11 -0.09997729806566429 -2.9897000000000005 0.7070673069132585 0.7070660141038305 -2.108573758305421e-10 -0.09997730496130686 -2.9898000000000002 0.707067319558492 0.7070660258323521 -4.0163380694152595e-10 -0.09997731185485509 -2.9899 0.707067332197853 0.7070660375593435 -6.022038727057644e-10 -0.0999773187463097 -2.99 0.7070673448312379 0.7070660492849103 -8.125183217216891e-10 -0.09997732563567129 -2.9901000000000004 0.7070673574585435 0.7070660610091579 -1.032525668263895e-09 -0.09997733252294051 -2.9902 0.7070673700796679 0.7070660727321907 -1.262172207895651e-09 -0.09997733940811802 -2.9903000000000004 0.7070673826945089 0.7070660844541126 -1.5014020261425176e-09 -0.09997734629120436 -2.9904 0.7070673953029654 0.707066096175027 -1.7501570141048584e-09 -0.0999773531722002 -2.9905 0.7070674079049372 0.7070661078950368 -2.008376880600904e-09 -0.09997736005110625 -2.9906 0.7070674205003245 0.7070661196142438 -2.2759991747181574e-09 -0.0999773669279231 -2.9907000000000004 0.7070674330890281 0.7070661313327494 -2.5529592918849264e-09 -0.09997737380265134 -2.9908 0.7070674456709496 0.707066143050654 -2.8391904938196433e-09 -0.0999773806752916 -2.9909 0.7070674582459917 0.7070661547680579 -3.134623920673929e-09 -0.09997738754584462 -2.991 0.7070674708140572 0.7070661664850599 -3.4391886083798284e-09 -0.09997739441431096 -2.9911000000000003 0.7070674833750503 0.7070661782017582 -3.752811518140109e-09 -0.09997740128069124 -2.9912 0.7070674959288754 0.7070661899182504 -4.075417529489367e-09 -0.09997740814498608 -2.9913000000000003 0.7070675084754383 0.7070662016346332 -4.406929481060029e-09 -0.09997741500719615 -2.9914 0.7070675210146455 0.7070662133510025 -4.747268175786523e-09 -0.09997742186732211 -2.9915 0.7070675335464041 0.7070662250674532 -5.096352407793492e-09 -0.09997742872536454 -2.9916000000000005 0.7070675460706223 0.7070662367840793 -5.454098974538857e-09 -0.0999774355813241 -2.9917000000000002 0.7070675585872093 0.7070662485009738 -5.820422702834671e-09 -0.09997744243520139 -2.9918 0.7070675710960753 0.7070662602182288 -6.195236465326992e-09 -0.09997744928699707 -2.9919000000000002 0.7070675835971314 0.7070662719359359 -6.578451200445201e-09 -0.09997745613671179 -2.992 0.7070675960902895 0.707066283654185 -6.969975935820771e-09 -0.09997746298434619 -2.9921 0.7070676085754625 0.7070662953730658 -7.369717808236587e-09 -0.0999774698299009 -2.9922000000000004 0.7070676210525642 0.7070663070926658 -7.777582089647794e-09 -0.09997747667337648 -2.9923 0.7070676335215103 0.7070663188130728 -8.19347220452904e-09 -0.09997748351477365 -2.9924 0.7070676459822163 0.7070663305343727 -8.617289758497404e-09 -0.099977490354093 -2.9925 0.7070676584345996 0.7070663422566503 -9.048934550455467e-09 -0.09997749719133514 -2.9926000000000004 0.7070676708785786 0.7070663539799895 -9.488304609020504e-09 -0.0999775040265007 -2.9927 0.7070676833140725 0.7070663657044735 -9.935296212473799e-09 -0.09997751085959032 -2.9928000000000003 0.7070676957410023 0.707066377430184 -1.0389803906975248e-08 -0.0999775176906047 -2.9929 0.7070677081592891 0.7070663891572011 -1.0851720542125187e-08 -0.09997752451954436 -2.993 0.707067720568856 0.7070664008856042 -1.1320937287877947e-08 -0.09997753134640995 -2.9931000000000005 0.7070677329696273 0.7070664126154715 -1.1797343660996384e-08 -0.09997753817120211 -2.9932000000000003 0.7070677453615284 0.7070664243468804 -1.2280827555409546e-08 -0.0999775449939216 -2.9933 0.7070677577444853 0.7070664360799064 -1.2771275265197751e-08 -0.09997755181456891 -2.9934000000000003 0.7070677701184257 0.7070664478146238 -1.326857151191449e-08 -0.09997755863314466 -2.9935 0.707067782483279 0.7070664595511058 -1.3772599472341995e-08 -0.09997756544964953 -2.9936000000000003 0.7070677948389752 0.7070664712894246 -1.4283240805813141e-08 -0.09997757226408412 -2.9937000000000005 0.7070678071854463 0.7070664830296509 -1.4800375681099653e-08 -0.09997757907644911 -2.9938000000000002 0.7070678195226248 0.7070664947718539 -1.532388280503505e-08 -0.0999775858867451 -2.9939 0.7070678318504446 0.7070665065161015 -1.5853639450270213e-08 -0.09997759269497271 -2.994 0.7070678441688417 0.7070665182624605 -1.6389521486498415e-08 -0.09997759950113255 -2.9941000000000004 0.707067856477753 0.7070665300109965 -1.6931403404307765e-08 -0.09997760630522533 -2.9942 0.7070678687771165 0.7070665417617732 -1.7479158352911445e-08 -0.09997761310725156 -2.9943 0.7070678810668716 0.7070665535148534 -1.803265816183175e-08 -0.09997761990721192 -2.9944 0.7070678933469596 0.7070665652702982 -1.8591773373426157e-08 -0.09997762670510707 -2.9945 0.7070679056173229 0.7070665770281674 -1.915637327541339e-08 -0.09997763350093757 -2.9946 0.7070679178779053 0.7070665887885195 -1.9726325927327953e-08 -0.09997764029470411 -2.9947000000000004 0.707067930128652 0.7070666005514114 -2.0301498198684043e-08 -0.09997764708640729 -2.9948 0.7070679423695099 0.7070666123168985 -2.0881755788924872e-08 -0.09997765387604773 -2.9949 0.7070679546004267 0.7070666240850347 -2.1466963269056033e-08 -0.09997766066362604 -2.995 0.7070679668213526 0.707066635855873 -2.2056984106365307e-08 -0.0999776674491429 -2.9951000000000003 0.7070679790322385 0.7070666476294643 -2.2651680701285537e-08 -0.0999776742325989 -2.9952 0.7070679912330367 0.7070666594058583 -2.3250914416451246e-08 -0.09997768101399465 -2.9953000000000003 0.7070680034237018 0.7070666711851028 -2.385454560835734e-08 -0.09997768779333081 -2.9954 0.7070680156041891 0.707066682967245 -2.4462433663788308e-08 -0.099977694570608 -2.9955 0.7070680277744559 0.7070666947523294 -2.507443702757378e-08 -0.09997770134582688 -2.9956000000000005 0.7070680399344609 0.7070667065403998 -2.5690413239451426e-08 -0.09997770811898801 -2.9957000000000003 0.707068052084164 0.7070667183314983 -2.631021896355723e-08 -0.09997771489009204 -2.9958 0.7070680642235272 0.7070667301256649 -2.6933710027456786e-08 -0.09997772165913955 -2.9959000000000002 0.7070680763525139 0.7070667419229392 -2.7560741449033505e-08 -0.09997772842613128 -2.996 0.7070680884710888 0.7070667537233579 -2.8191167474435688e-08 -0.09997773519106778 -2.9961 0.7070681005792183 0.7070667655269569 -2.882484161125312e-08 -0.09997774195394965 -2.9962000000000004 0.7070681126768705 0.7070667773337705 -2.9461616660826292e-08 -0.0999777487147775 -2.9963 0.7070681247640149 0.7070667891438313 -3.010134475532611e-08 -0.099977755473552 -2.9964 0.7070681368406233 0.7070668009571701 -3.074387738876208e-08 -0.09997776223027383 -2.9965 0.707068148906668 0.7070668127738164 -3.138906545449571e-08 -0.0999777689849435 -2.9966000000000004 0.7070681609621237 0.7070668245937979 -3.2036759278850774e-08 -0.09997777573756168 -2.9967 0.7070681730069659 0.7070668364171409 -3.268680865298884e-08 -0.099977782488129 -2.9968000000000004 0.7070681850411729 0.7070668482438696 -3.333906287237426e-08 -0.09997778923664606 -2.9969 0.7070681970647239 0.707066860074007 -3.399337076734864e-08 -0.09997779598311349 -2.997 0.7070682090775997 0.7070668719075747 -3.464958074281266e-08 -0.09997780272753197 -2.9971000000000005 0.7070682210797827 0.707066883744592 -3.530754081010161e-08 -0.09997780946990202 -2.9972000000000003 0.7070682330712572 0.7070668955850772 -3.5967098622330385e-08 -0.09997781621022434 -2.9973 0.7070682450520094 0.7070669074290468 -3.662810150952163e-08 -0.09997782294849959 -2.9974000000000003 0.7070682570220264 0.7070669192765151 -3.7290396515685456e-08 -0.09997782968472832 -2.9975 0.7070682689812974 0.7070669311274951 -3.7953830433839174e-08 -0.09997783641891111 -2.9976000000000003 0.7070682809298132 0.7070669429819982 -3.8618249838316514e-08 -0.09997784315104866 -2.9977000000000005 0.7070682928675661 0.707066954840035 -3.928350112477469e-08 -0.09997784988114158 -2.9978000000000002 0.7070683047945503 0.7070669667016127 -3.994943054179889e-08 -0.09997785660919047 -2.9979 0.7070683167107616 0.7070669785667383 -4.0615884230367234e-08 -0.09997786333519597 -2.998 0.7070683286161972 0.7070669904354163 -4.1282708255455276e-08 -0.09997787005915867 -2.9981000000000004 0.7070683405108561 0.7070670023076497 -4.1949748644335436e-08 -0.09997787678107918 -2.9982 0.7070683523947392 0.7070670141834405 -4.261685141998398e-08 -0.09997788350095818 -2.9983 0.7070683642678489 0.7070670260627885 -4.3283862638919686e-08 -0.09997789021879627 -2.9984 0.7070683761301888 0.7070670379456915 -4.3950628424854754e-08 -0.09997789693459402 -2.9985 0.7070683879817645 0.7070670498321463 -4.461699500501559e-08 -0.09997790364835207 -2.9986 0.707068399822584 0.7070670617221477 -4.528280874460688e-08 -0.09997791036007109 -2.9987000000000004 0.7070684116526558 0.7070670736156892 -4.5947916185219446e-08 -0.09997791706975169 -2.9988 0.7070684234719904 0.7070670855127621 -4.661216407541831e-08 -0.09997792377739441 -2.9989 0.7070684352805999 0.7070670974133564 -4.7275399410126335e-08 -0.09997793048299992 -2.999 0.7070684470784985 0.7070671093174604 -4.793746946347554e-08 -0.09997793718656883 -2.9991000000000003 0.7070684588657018 0.7070671212250612 -4.859822182602235e-08 -0.09997794388810183 -2.9992 0.7070684706422268 0.7070671331361436 -4.925750443814103e-08 -0.0999779505875995 -2.9993000000000003 0.7070684824080922 0.7070671450506907 -4.9915165624067614e-08 -0.09997795728506242 -2.9994 0.7070684941633181 0.7070671569686846 -5.0571054130551726e-08 -0.09997796398049118 -2.9995 0.7070685059079269 0.7070671688901053 -5.122501915797318e-08 -0.09997797067388645 -2.9996000000000005 0.7070685176419423 0.7070671808149316 -5.187691039612065e-08 -0.09997797736524888 -2.9997000000000003 0.7070685293653893 0.7070671927431402 -5.252657805931982e-08 -0.09997798405457903 -2.9998 0.707068541078295 0.7070672046747066 -5.317387292156153e-08 -0.09997799074187752 -2.9999000000000002 0.7070685527806873 0.7070672166096044 -5.381864634675104e-08 -0.09997799742714493 diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in b/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in index 37d1e3765a..ed8a5caeaf 100644 --- a/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in @@ -15,7 +15,6 @@ create_atoms 1 box mass 1 1.0 set type 1 spin 2.0 1.0 0.0 0.0 -# defines a pair/style for neighbor list, but do not use it pair_style spin/exchange 4.0 pair_coeff * * exchange 1.0 0.0 0.0 1.0 @@ -24,7 +23,7 @@ group bead type 1 variable H equal 10.0 variable Kan equal 0.0 variable Temperature equal 0.0 -variable RUN equal 100000 +variable Nsteps equal 500000 fix 1 all nve/spin lattice no fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 @@ -45,4 +44,4 @@ thermo 100 timestep 0.0001 -run ${RUN} +run ${Nsteps} diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py b/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py index edaa4f22cc..e8a46f389a 100755 --- a/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py @@ -17,7 +17,7 @@ Bext = np.array([0.0, 0.0, 1.0]) Sn = 2.0 # spin norm (in # of muB) S = np.array([1.0, 0.0, 0.0]) -N=100000 # number of timesteps +N=500000 # number of timesteps dt=0.1 # timestep (fs) # Rodrigues rotation formula @@ -46,6 +46,7 @@ for t in range (0,N): theta=dt*np.linalg.norm(wf) axis=wf/np.linalg.norm(wf) S = np.dot(rotation_matrix(axis, theta), S) + en = -hbar*gyro*Sn*Bnrm*np.dot(S,Bext) # print res. in ps for comparison with LAMMPS - print(t*dt/1000.0,S[0],S[1],S[2]) + print(t*dt/1000.0,S[0],S[1],S[2],en) diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py b/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py index c15d6c0ff5..9c07f1cefa 100755 --- a/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py +++ b/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py @@ -15,25 +15,31 @@ if len(argv) != 3: lammps_file = sys.argv[1] llg_file = sys.argv[2] -t_lmp,Sx_lmp,Sy_lmp,Sz_lmp = np.loadtxt(lammps_file, skiprows=0, usecols=(1,2,3,4),unpack=True) -t_llg,Sx_llg,Sy_llg,Sz_llg = np.loadtxt(llg_file, skiprows=0, usecols=(0,1,2,3),unpack=True) +t_lmp,Sx_lmp,Sy_lmp,Sz_lmp,en_lmp = np.loadtxt(lammps_file, + skiprows=0, usecols=(1,2,3,4,5),unpack=True) +t_llg,Sx_llg,Sy_llg,Sz_llg,en_llg = np.loadtxt(llg_file, skiprows=0, usecols=(0,1,2,3,4),unpack=True) plt.figure() -plt.subplot(311) +plt.subplot(411) plt.ylabel('Sx') plt.plot(t_lmp, Sx_lmp, 'b-', label='LAMMPS') plt.plot(t_llg, Sx_llg, 'r--', label='LLG') -plt.subplot(312) +plt.subplot(412) plt.ylabel('Sy') plt.plot(t_lmp, Sy_lmp, 'b-', label='LAMMPS') plt.plot(t_llg, Sy_llg, 'r--', label='LLG') -plt.subplot(313) +plt.subplot(413) plt.ylabel('Sz') plt.plot(t_lmp, Sz_lmp, 'b-', label='LAMMPS') plt.plot(t_llg, Sz_llg, 'r--', label='LLG') +plt.subplot(414) +plt.ylabel('En (eV)') +plt.plot(t_lmp, en_lmp, 'b-', label='LAMMPS') +plt.plot(t_llg, en_llg, 'r--', label='LLG') + plt.xlabel('time (in ps)') plt.legend() plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template b/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template deleted file mode 100644 index c4286e3597..0000000000 --- a/examples/SPIN/benchmark/benchmarck_langevin_exchange/bench-exchange-spin.template +++ /dev/null @@ -1,41 +0,0 @@ -#LAMMPS in.run - -units metal -atom_style spin -atom_modify map array -boundary p p p - -lattice sc 3.0 -region box block 0.0 2.0 0.0 2.0 0.0 2.0 -create_box 1 box -create_atoms 1 box - -mass 1 1.0 -set type 1 spin 1.0 0.0 0.0 1.0 - -# defines a pair/style for neighbor list, but do not use it -pair_style spin/exchange 3.1 -pair_coeff * * exchange 3.1 11.254 0.0 1.0 - -variable H equal 0.0 -variable Kan equal 0.0 -variable Temperature equal temperature -variable RUN equal 100000 - -fix 1 all nve/spin lattice no -fix 2 all precession/spin zeeman ${H} 0.0 0.0 1.0 anisotropy ${Kan} 0.0 0.0 1.0 -fix 3 all langevin/spin ${Temperature} 0.01 12345 - -thermo 500000 -thermo_style custom step time temp vol -timestep 0.1 - -compute compute_spin all spin -variable mag_energy equal c_compute_spin[5] -variable AVEs equal c_compute_spin[4] - -fix avespin all ave/time 1 ${RUN} ${RUN} v_Temperature v_H v_Kan v_AVEs v_mag_energy file _av_spin - -run ${RUN} - -shell cat _av_spin diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py b/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py deleted file mode 100755 index d543f86cba..0000000000 --- a/examples/SPIN/benchmark/benchmarck_langevin_exchange/langevin-exchange.py +++ /dev/null @@ -1,34 +0,0 @@ -#!/usr/bin/env python3 - -import numpy as np, pylab, tkinter -import matplotlib.pyplot as plt -import mpmath as mp - -mub=5.78901e-5 # Bohr magneton (eV/T) -kb=8.617333262145e-5 # Boltzman constant (eV/K) -J0=0.05 # per-neighbor exchange interaction (eV) -z=6 # number of NN (bcc) -g=2.0 # Lande factor (adim) -Hz=10.0 # mag. field (T) - -#Definition of the Langevin function -def func(sm,t): - return mp.coth(z*J0*sm/(kb*t))-1.0/(z*J0*sm/(kb*t)) - -npoints=200 -tolerance=1e-5 -ti=0.01 -tf=2000.0 -sz=1.0 -szg=0.5 -for i in range (0,npoints): - temp=ti+i*(tf-ti)/npoints - count=0 - sz=1.0 - szg=0.5 - while (abs(sz-szg)) >= tolerance: - sz=szg - szg=func(sz,temp) - count+=1 - emag=-z*J0*sz*sz - print('%d %lf %lf %lf %lf' % (temp,szg,sz,emag,count)) diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py b/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py deleted file mode 100755 index 8fa6f55589..0000000000 --- a/examples/SPIN/benchmark/benchmarck_langevin_exchange/plot_exchange.py +++ /dev/null @@ -1,34 +0,0 @@ -#!/usr/bin/env python3 - -import numpy as np, pylab, tkinter -import matplotlib.pyplot as plt -from scipy.optimize import curve_fit -from decimal import * -import sys, string, os - - -argv = sys.argv -if len(argv) != 3: - print("Syntax: ./plot_precession.py res_lammps.dat res_langevin.dat") - sys.exit() - -lammps_file = sys.argv[1] -langevin_file = sys.argv[2] - -T_lmp,S_lmp,E_lmp = np.loadtxt(lammps_file, skiprows=0, usecols=(0,2,3),unpack=True) -T_lan,S_lan,E_lan = np.loadtxt(langevin_file, skiprows=0, usecols=(0,2,3),unpack=True) - -plt.figure() -plt.subplot(211) -plt.ylabel('') -plt.plot(T_lmp, S_lmp, 'b-', label='LAMMPS') -plt.plot(T_lan, S_lan, 'r--', label='Langevin') - -plt.subplot(212) -plt.ylabel('E (in eV)') -plt.plot(T_lmp, E_lmp, 'b-', label='LAMMPS') -plt.plot(T_lan, E_lan, 'r--', label='Langevin') - -plt.xlabel('T (in K)') -plt.legend() -plt.show() diff --git a/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh b/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh deleted file mode 100755 index d631fdbc79..0000000000 --- a/examples/SPIN/benchmark/benchmarck_langevin_exchange/run-bench-exchange.sh +++ /dev/null @@ -1,28 +0,0 @@ -#!/bin/bash - -# set initial and final temperature (K) -tempi=0.0 -tempf=2000.0 - -rm res_*.dat - -# run Lammps calculation -N=20 -for (( i=0; i<$N; i++ )) -do - temp="$(echo "$tempi+$i*($tempf-$tempi)/$N" | bc -l)" - sed s/temperature/${temp}/g bench-exchange-spin.template > \ - bench-exchange-spin.in - ../../../../src/lmp_serial \ - -in bench-exchange-spin.in - Hz="$(tail -n 1 _av_spin | awk -F " " '{print $3}')" - sm="$(tail -n 1 _av_spin | awk -F " " '{print $5}')" - en="$(tail -n 1 _av_spin | awk -F " " '{print $6}')" - echo $temp $Hz $sm $en >> res_lammps.dat -done - -# run Langevin function calculation -python3 -m langevin-exchange.py > res_langevin.dat - -# plot comparison -python3 -m plot_exchange.py res_lammps.dat res_langevin.dat diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template b/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template index 6e79fe9d25..52f6a105ea 100644 --- a/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template @@ -33,14 +33,14 @@ fix 3 all langevin/spin ${Temperature} 0.01 12345 compute compute_spin all spin compute outsp all property/atom spx spy spz sp -compute AVEsz all reduce ave c_outsp[3] +compute magsz all reduce ave c_outsp[3] thermo 50000 thermo_style custom step time temp vol pe c_compute_spin[5] etotal variable magnetic_energy equal c_compute_spin[5] -fix avespin all ave/time 1 ${RUN} ${RUN} v_Temperature v_H v_Kan c_AVEsz v_magnetic_energy file _av_spin +fix avespin all ave/time 1 ${RUN} ${RUN} v_Temperature v_H v_Kan c_magsz v_magnetic_energy file average_spin timestep 0.1 run ${RUN} diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh b/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh index ecbe7d2eff..98fceeca95 100755 --- a/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh +++ b/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh @@ -14,9 +14,9 @@ do bench-prec-spin.in ./../../../../src/lmp_serial \ -in bench-prec-spin.in - Hz="$(tail -n 1 _av_spin | awk -F " " '{print $3}')" - sz="$(tail -n 1 _av_spin | awk -F " " '{print $5}')" - en="$(tail -n 1 _av_spin | awk -F " " '{print $6}')" + Hz="$(tail -n 1 average_spin | awk -F " " '{print $3}')" + sz="$(tail -n 1 average_spin | awk -F " " '{print $5}')" + en="$(tail -n 1 average_spin | awk -F " " '{print $6}')" echo $temp $Hz $sz $en >> res_lammps.dat done diff --git a/src/SPIN/compute_spin.cpp b/src/SPIN/compute_spin.cpp index 7d7fb56e1c..7ee2b5bcfc 100644 --- a/src/SPIN/compute_spin.cpp +++ b/src/SPIN/compute_spin.cpp @@ -104,7 +104,6 @@ void ComputeSpin::compute_vector() mag[0] += sp[i][0]; mag[1] += sp[i][1]; mag[2] += sp[i][2]; - // magenergy -= 2.0*(sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); magenergy -= (sp[i][0]*fm[i][0] + sp[i][1]*fm[i][1] + sp[i][2]*fm[i][2]); tx = sp[i][1]*fm[i][2]-sp[i][2]*fm[i][1]; ty = sp[i][2]*fm[i][0]-sp[i][0]*fm[i][2]; @@ -129,7 +128,6 @@ void ComputeSpin::compute_vector() magtot[2] *= scale; magtot[3] = sqrt((magtot[0]*magtot[0])+(magtot[1]*magtot[1])+(magtot[2]*magtot[2])); spintemperature = hbar*tempnumtot; - // spintemperature /= (kb*tempdenomtot); spintemperature /= (2.0*kb*tempdenomtot); vector[0] = magtot[0]; diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index 263118f5fb..93f8ef9d32 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -257,7 +257,6 @@ void FixPrecessionSpin::post_force(int /* vflag */) if (zeeman_flag) { // compute Zeeman interaction compute_zeeman(i,fmi); - // epreci -= 2.0*hbar*(spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); epreci -= hbar*(spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); } @@ -296,9 +295,6 @@ void FixPrecessionSpin::compute_single_precession(int i, double spi[3], double f void FixPrecessionSpin::compute_zeeman(int i, double fmi[3]) { double **sp = atom->sp; - // fmi[0] += 0.5*sp[i][3]*hx; - // fmi[1] += 0.5*sp[i][3]*hy; - // fmi[2] += 0.5*sp[i][3]*hz; fmi[0] += sp[i][3]*hx; fmi[1] += sp[i][3]*hy; fmi[2] += sp[i][3]*hz; @@ -309,9 +305,9 @@ void FixPrecessionSpin::compute_zeeman(int i, double fmi[3]) void FixPrecessionSpin::compute_anisotropy(double spi[3], double fmi[3]) { double scalar = nax*spi[0] + nay*spi[1] + naz*spi[2]; - fmi[0] += 0.5*scalar*Kax; - fmi[1] += 0.5*scalar*Kay; - fmi[2] += 0.5*scalar*Kaz; + fmi[0] += scalar*Kax; + fmi[1] += scalar*Kay; + fmi[2] += scalar*Kaz; } /* ---------------------------------------------------------------------- */ @@ -320,7 +316,7 @@ double FixPrecessionSpin::compute_anisotropy_energy(double spi[3]) { double energy = 0.0; double scalar = nax*spi[0] + nay*spi[1] + naz*spi[2]; - energy = 2.0*Ka*scalar*scalar; + energy = Ka*scalar*scalar; return energy; } @@ -358,9 +354,9 @@ void FixPrecessionSpin::compute_cubic(double spi[3], double fmi[3]) sixy = k2ch*(nc1y*six1 + nc2y*six2 + nc3y*six3); sixz = k2ch*(nc1z*six1 + nc2z*six2 + nc3z*six3); - fmi[0] += 0.5*(fourx + sixx); - fmi[1] += 0.5*(foury + sixy); - fmi[2] += 0.5*(fourz + sixz); + fmi[0] += (fourx + sixx); + fmi[1] += (foury + sixy); + fmi[2] += (fourz + sixz); } /* ---------------------------------------------------------------------- @@ -379,7 +375,7 @@ double FixPrecessionSpin::compute_cubic_energy(double spi[3]) energy = k1c*(skx*skx*sky*sky + sky*sky*skz*skz + skx*skx*skz*skz); energy += k2c*skx*skx*sky*sky*skz*skz; - return 2.0*energy; + return energy; } /* ---------------------------------------------------------------------- */ diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index d547de6995..2aa8b99f32 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -242,7 +242,6 @@ void PairSpinExchange::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - // evdwl *= 0.5*hbar; evdwl *= hbar; } else evdwl = 0.0; @@ -352,11 +351,6 @@ void PairSpinExchange::compute_exchange(int i, int j, double rsq, double fmi[3], Jex *= (1.0-J2[itype][jtype]*ra); Jex *= exp(-ra); - // printf("Exchange : %g %g \n",Jex,Jex*hbar); - - // fmi[0] += 2.0*Jex*spj[0]; - // fmi[1] += 2.0*Jex*spj[1]; - // fmi[2] += 2.0*Jex*spj[2]; fmi[0] += Jex*spj[0]; fmi[1] += Jex*spj[1]; fmi[2] += Jex*spj[2]; From 31ac2f3bd13ccc510c21e72b9620be8ebc976679 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 15 Nov 2019 11:42:04 -0700 Subject: [PATCH 434/557] Commit2 JT 151119 - adding doc exceptions to false-positives --- doc/utils/sphinx-config/false_positives.txt | 5 +++++ 1 file changed, 5 insertions(+) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 5b3020c7d1..8bc437bd48 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -212,6 +212,7 @@ Berne Bertotti Bessarab Beutler +Bext bgq Bh Biersack @@ -1041,6 +1042,7 @@ Gunsteren Gunzenmuller Guo gw +gyromagnetic gz gzipped Haak @@ -1060,6 +1062,7 @@ Haswell Haugk Hayoun Hayre +hbar hbcut hbn hbnewflag @@ -1401,6 +1404,7 @@ Lammps LAMMPS lammpsplot Lamoureux +Lande Landron langevin Langevin @@ -1772,6 +1776,7 @@ mtk Mtotal muB Muccioli +mui Mukherjee Mulders multi From f4491011d0d12733d6763b0dfa2c5ee4edb26695 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 18:54:37 +0000 Subject: [PATCH 435/557] Modified README --- examples/USER/cgdna/README | 28 ++++++++++++++-------------- 1 file changed, 14 insertions(+), 14 deletions(-) diff --git a/examples/USER/cgdna/README b/examples/USER/cgdna/README index 7cbf76fd5a..49b7cd1f84 100644 --- a/examples/USER/cgdna/README +++ b/examples/USER/cgdna/README @@ -1,6 +1,6 @@ This directory contains example data and input files as well as utility scripts for the oxDNA/oxDNA2/oxRNA2 -coarse-grained model for DNA and RNA. +coarse-grained model of DNA and RNA. /******************************************************************************/ @@ -40,15 +40,14 @@ are sequence-averaged (cf. keyword 'seqav' in according pair styles). /examples/oxDNA2/duplex3: -This is 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. +This example uses the duplex1 with sequence-dependent stacking and +hydrogen-bonding interactions and both nucleotide mass and +moment of inertia set to the value used in the standalone implementation +of oxDNA (M = I = 1). 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. +trajectory data or time-dependent observables on a per-timestep basis. As mentioned above, the stacking and hydrogen-bonding interactions are sequence-dependent (cf. keyword 'seqdep' in according pair styles). @@ -60,8 +59,6 @@ are sequence-dependent (cf. keyword 'seqdep' in according pair styles). This example uses atom types 1-8 to model a 13 base pair duplex. The nucleotide types are assigned as follows: A = 1,5; C = 2,6; G = 3,7; T = 4,8 -When a large number of atom types is used, this feature allows -quasi-unique base pairing between two individual nucleotides. The topology is A C G T A C G T A C G T A @@ -70,13 +67,16 @@ A C G T A C G T A C G T A 4 - 3 - 2 - 1 - 8 - 7 - 6 - 5 - 4 - 3 - 6 - 5 - 4 T G C A T G C A T G C A T +With a large (32 or 64) number of atom types quasi-unique base pairing +between two individual nucleotides can be established. + /******************************************************************************/ /examples/oxRNA2/duplex4 -This is the duplex2 run with the oxRNA2 force field instead of the oxDNA or -oxDNA2 force field and sequence-dependent stacking and hydrogen-bonding -strengths enabled. +This example uses the duplex2 with the oxRNA2 force field instead of oxDNA or +oxDNA2 force field. Sequence-dependent stacking and hydrogen-bonding +strengths enabled (cf. keyword 'seqdep' in according pair styles). /******************************************************************************/ From 3d106c7d47a9ef230e26799f3eca7c35b7f49756 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 13:50:30 -0500 Subject: [PATCH 436/557] replace non-ascii character --- doc/src/Install_conda.rst | 9 ++------- 1 file changed, 2 insertions(+), 7 deletions(-) diff --git a/doc/src/Install_conda.rst b/doc/src/Install_conda.rst index 04b8054353..33188e2540 100644 --- a/doc/src/Install_conda.rst +++ b/doc/src/Install_conda.rst @@ -32,12 +32,10 @@ install the `openkim-models` package If you have problems with the installation you can post issues to `this link `_. - -.. _conda_forge_lammps: https://github.com/conda-forge/lammps-feedstock/issues - -Thanks to Jan Janssen (Max-Planck-Institut für Eisenforschung) for setting +Thanks to Jan Janssen (Max-Planck-Institut fuer Eisenforschung) for setting up the Conda capability. +.. _conda_forge_lammps: https://github.com/conda-forge/lammps-feedstock/issues .. _openkim: https://openkim.org @@ -45,9 +43,6 @@ up the Conda capability. .. _mini_conda_install: https://docs.conda.io/en/latest/miniconda.html - - - .. _lws: http://lammps.sandia.gov .. _ld: Manual.html .. _lc: Commands_all.html From e287cd975bb693f1daaf01ffec5d6d46bc2eed39 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Thu, 14 Nov 2019 12:36:05 -0500 Subject: [PATCH 437/557] update README --- doc/README | 28 +++++++++++++--------------- 1 file changed, 13 insertions(+), 15 deletions(-) diff --git a/doc/README b/doc/README index 6db4ba3ca7..96b17f9bf5 100644 --- a/doc/README +++ b/doc/README @@ -5,7 +5,7 @@ sub-directories and optionally 2 PDF files and an ePUB file: src content files for LAMMPS documentation html HTML version of the LAMMPS manual (see html/Manual.html) -tools tools and settings for building the documentation +utils utilities and settings for building the documentation Manual.pdf large PDF version of entire manual Developer.pdf small PDF with info about how LAMMPS is structured LAMMPS.epub Manual in ePUB format @@ -25,17 +25,12 @@ the fetched documentation will include those changes (but your source code will not, unless you update your local repository). (b) You can build the HTML and PDF files yourself, by typing "make -html" followed by "make pdf". Note that the PDF make requires the -HTML files already exist. This requires various tools including -Sphinx, which the build process will attempt to download and install -on your system, if not already available. See more details below. - -(c) You can genererate an older, simpler, less-fancy style of HTML -documentation by typing "make old". This will create an "old" -directory. This can be useful if (b) does not work on your box for -some reason, or you want to quickly view the HTML version of a doc -page you have created or edited yourself within the src directory. -E.g. if you are planning to submit a new feature to LAMMPS. +html" or by "make pdf", respectively. This requires various tools +including the Python documentation processing tool Sphinx, which the +build process will attempt to download and install on your system into +a python virtual environment, if not already available. The PDF file +will require a working LaTeX installation with several add-on packages +in addition to the Python/Sphinx setup. See more details below. ---------------- @@ -47,10 +42,9 @@ Options: make html # generate HTML in html dir using Sphinx make pdf # generate 2 PDF files (Manual.pdf,Developer.pdf) # in this dir via htmldoc and pdflatex -make old # generate old-style HTML pages in old dir via txt2html make fetch # fetch HTML doc pages and 2 PDF files from web site # as a tarball and unpack into html dir and 2 PDFs -make epub # generate LAMMPS.epub in ePUB format using Sphinx +make epub # generate LAMMPS.epub in ePUB format using Sphinx make clean # remove intermediate RST files created by HTML build make clean-all # remove entire build folder and any cached data @@ -103,7 +97,11 @@ Installing prerequisites for epub build ## ePUB Same as for HTML. This uses the same tools and configuration -files as the HTML tree. +files as the HTML tree. The ePUB format conversion currently +does not support processing mathematical expressions via MathJAX, +so there will be limitations on some pages. For the time being +until this is resolved, building and using the PDF format file +is recommended instead. For converting the generated ePUB file to a mobi format file (for e-book readers like Kindle, that cannot read ePUB), you From 08044dcd35c1aa49318fdaf04d6e8b0fffeba109 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 15 Nov 2019 14:21:44 -0500 Subject: [PATCH 438/557] update README for "make pdf" and list dependencies --- doc/README | 15 ++++++++++++--- 1 file changed, 12 insertions(+), 3 deletions(-) diff --git a/doc/README b/doc/README index 96b17f9bf5..1416584eed 100644 --- a/doc/README +++ b/doc/README @@ -41,7 +41,7 @@ Options: make html # generate HTML in html dir using Sphinx make pdf # generate 2 PDF files (Manual.pdf,Developer.pdf) - # in this dir via htmldoc and pdflatex + # in this dir via Sphinx and PDFLaTeX make fetch # fetch HTML doc pages and 2 PDF files from web site # as a tarball and unpack into html dir and 2 PDFs make epub # generate LAMMPS.epub in ePUB format using Sphinx @@ -88,8 +88,17 @@ This will install virtualenv from the Python Package Index. Installing prerequisites for PDF build -[TBA] - +Same as for HTML plus a compatible LaTeX installation with +support for PDFLaTeX. Also the following LaTeX packages need +to be installed (e.g. from texlive): +- amsmath +- babel +- cmap +- fncychap +- geometry +- hyperref +- hypcap +- times ---------------- Installing prerequisites for epub build From 5ddac24161943cc04ac1a6a1ffb68d3a541d56b8 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 19:27:48 +0000 Subject: [PATCH 439/557] Modified README --- src/USER-CGDNA/{README => README.md} | 6 +++++- 1 file changed, 5 insertions(+), 1 deletion(-) rename src/USER-CGDNA/{README => README.md} (95%) diff --git a/src/USER-CGDNA/README b/src/USER-CGDNA/README.md similarity index 95% rename from src/USER-CGDNA/README rename to src/USER-CGDNA/README.md index a57168e53e..138638525e 100644 --- a/src/USER-CGDNA/README +++ b/src/USER-CGDNA/README.md @@ -2,7 +2,11 @@ This package contains a LAMMPS implementation of coarse-grained models of DNA, which can be used to model sequence-specific DNA strands. -Please cite [1] and the relevant oxDNA, oxDNA2 and oxRNA2 articles +Please cite + +[![DOI](https://zenodo.org/badge/132764768.svg)](https://zenodo.org/badge/latestdoi/132764768) + +as well as [1] and the relevant oxDNA, oxDNA2 and oxRNA2 articles in any publication that uses this package. See the doc pages and [2,3,4,5,6] for the individual bond and pair styles. From 95de27d8d1760db3c16f18bfa4773ca6615ca4dc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 15 Nov 2019 14:31:33 -0500 Subject: [PATCH 440/557] correct false positives to not have non-ASCII characters --- doc/utils/sphinx-config/false_positives.txt | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/utils/sphinx-config/false_positives.txt b/doc/utils/sphinx-config/false_positives.txt index 5b3020c7d1..fee8f2fbe9 100644 --- a/doc/utils/sphinx-config/false_positives.txt +++ b/doc/utils/sphinx-config/false_positives.txt @@ -933,7 +933,7 @@ funcs functionalities functionals funroll -für +fuer fx fy fz From 2c2b7cf20bd85a315e175534354cbb507573541f Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 21:19:33 +0000 Subject: [PATCH 441/557] Corrected linking error --- doc/src/pair_oxrna2.rst | 16 ++++++++++++---- 1 file changed, 12 insertions(+), 4 deletions(-) diff --git a/doc/src/pair_oxrna2.rst b/doc/src/pair_oxrna2.rst index 469851eb5a..c9d8314682 100644 --- a/doc/src/pair_oxrna2.rst +++ b/doc/src/pair_oxrna2.rst @@ -75,7 +75,7 @@ excluded volume interaction *oxrna2/excv*\ , the stacking *oxrna2/stk*\ , cross- and coaxial stacking interaction *oxrna2/coaxstk*\ , electrostatic Debye-Hueckel interaction *oxrna2/dh* as well as the hydrogen-bonding interaction *oxrna2/hbond* between complementary pairs of nucleotides on opposite strands. Average sequence or sequence-dependent stacking and base-pairing strengths -are supported :ref:`(Sulc) `. Quasi-unique base-pairing between nucleotides can be achieved by using +are supported :ref:`(Sulc2) `. Quasi-unique base-pairing between nucleotides can be achieved by using more complementary pairs of atom types like 5-8 and 6-7, 9-12 and 10-11, 13-16 and 14-15, etc. This prevents the hybridization of in principle complementary bases within Ntypes/4 bases up and down along the backbone. @@ -84,8 +84,8 @@ The exact functional form of the pair styles is rather complex. The individual potentials consist of products of modulation factors, which themselves are constructed from a number of more basic potentials (Morse, Lennard-Jones, harmonic angle and distance) as well as quadratic smoothing and modulation terms. -We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` -and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 force field. +We refer to :ref:`(Sulc1) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` +and :ref:`(Ouldridge) ` for a detailed description of the oxRNA2 force field. .. note:: @@ -103,7 +103,7 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` in any publication that uses +Please cite :ref:`(Henrich) ` in any publication that uses this implementation. The article contains general information on the model, its implementation and performance as well as the structure of the data and input file. The preprint version of the article can be found @@ -147,6 +147,14 @@ Related commands **(Sulc2)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). +.. _Ouldridge-DPhil3: + +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). + +.. _Ouldridge3: + +**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html From 2d6e84edd74bcf23ce569d04a37561eb1c0f6204 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 21:45:33 +0000 Subject: [PATCH 442/557] Fixed anchor errors --- doc/src/bond_oxdna.rst | 75 ++++++++++++------------------- doc/src/fix_nve_dot.rst | 16 +++---- doc/src/fix_nve_dotc_langevin.rst | 21 ++++----- doc/src/pair_oxdna.rst | 45 ++++++++++--------- doc/src/pair_oxdna2.rst | 53 ++++++++++++---------- 5 files changed, 96 insertions(+), 114 deletions(-) diff --git a/doc/src/bond_oxdna.rst b/doc/src/bond_oxdna.rst index 36370ddf30..51692f933b 100644 --- a/doc/src/bond_oxdna.rst +++ b/doc/src/bond_oxdna.rst @@ -6,9 +6,6 @@ bond\_style oxdna/fene command bond\_style oxdna2/fene command =============================== -bond\_style oxrna2/fene command -=============================== - Syntax """""" @@ -19,8 +16,6 @@ Syntax bond_style oxdna2/fene - bond_style oxrna2/fene - Examples """""""" @@ -33,21 +28,18 @@ Examples bond_style oxdna2/fene bond_coeff \* 2.0 0.25 0.7564 - bond_style oxrna2/fene - bond_coeff \* 2.0 0.25 0.76107 - Description """"""""""" -The *oxdna/fene* , *oxdna2/fene* and *oxrna2/fene* bond styles use the potential +The *oxdna/fene* and *oxdna2/fene* bond styles use the potential .. image:: Eqs/bond_oxdna_fene.jpg :align: center to define a modified finite extensible nonlinear elastic (FENE) -potential :ref:`(Ouldridge) ` to model the connectivity of the -phosphate backbone in the oxDNA/oxRNA force field for coarse-grained -modelling of DNA/RNA. +potential :ref:`(Ouldridge) ` to model the connectivity of the +phosphate backbone in the oxDNA force field for coarse-grained +modelling of DNA. The following coefficients must be defined for the bond type via the :doc:`bond\_coeff ` command as given in the above example, or @@ -63,36 +55,27 @@ commands: The oxDNA bond style has to be used together with the corresponding oxDNA pair styles for excluded volume interaction - *oxdna/excv* , stacking *oxdna/stk* , cross-stacking *oxdna/xstk* and + *oxdna/excv*\ , stacking *oxdna/stk*\ , cross-stacking *oxdna/xstk* and coaxial stacking interaction *oxdna/coaxstk* as well as hydrogen-bonding interaction *oxdna/hbond* (see also documentation of :doc:`pair\_style oxdna/excv `). For the oxDNA2 - :ref:`(Snodin) ` bond style the analogous pair styles - *oxdna2/excv* , *oxdna2/stk* , *oxdna2/xstk* , *oxdna2/coaxstk* , - *oxdna2/hbond* and an additional Debye-Hueckel pair style - *oxdna2/dh* have to be defined. The same applies to the oxRNA2 - :ref:`(Sulc1) ` styles. + :ref:`(Snodin) ` bond style the analogous pair styles and an + additional Debye-Hueckel pair style *oxdna2/dh* have to be defined. The coefficients in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. -Example input and data files for DNA and RNA duplexes can be found in -examples/USER/cgdna/examples/oxDNA/ , /oxDNA2/ and /oxRNA2/. A simple python -setup tool which creates single straight or helical DNA strands, DNA/RNA -duplexes or arrays of DNA/RNA duplexes can be found in +Example input and data files for DNA duplexes can be found in +examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. A simple python +setup tool which creates single straight or helical DNA strands, DNA +duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` in any publication that uses -this implementation. The article contains general information -on the model, its implementation and performance as well as the structure of -the data and input file. The preprint version of the article can be found +Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in +any publication that uses this implementation. The article contains +more information on the model, the structure of the input file, the +setup tool and the performance of the LAMMPS-implementation of oxDNA. +The preprint version of the article can be found `here `_. -Please cite also the relevant oxDNA/oxRNA publications. These are -:ref:`(Ouldridge) ` and -:ref:`(Ouldridge-DPhil) ` for oxDNA, -:ref:`(Snodin) ` for oxDNA2, -:ref:`(Sulc1) ` for oxRNA2 -and for sequence-specific hydrogen-bonding and stacking interactions -:ref:`(Sulc2) `. ---------- @@ -109,37 +92,35 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`pair\_style oxrna2/excv `, -:doc:`bond\_coeff `, :doc:`fix nve/dotc/langevin ` +:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`fix nve/dotc/langevin `, +:doc:`bond\_coeff ` **Default:** none ---------- -.. _Henrich0: -**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Henrich2: -.. _Ouldridge-DPhil0: -**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). -.. _Ouldridge0: +**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, +T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). +.. _oxdna\_fene: -.. _Snodin0: -**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). -.. _Sulc01: +**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, +J. Chem. Phys. 134, 085101 (2011). -**(Sulc1)** P. Sulc, F. Romano, T. E. Ouldridge, et al., J. Chem. Phys. 140, 235102 (2014). +.. _oxdna2: -.. _Sulc02: -**(Sulc2)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + +**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., +J. Chem. Phys. 142, 234901 (2015). .. _lws: http://lammps.sandia.gov diff --git a/doc/src/fix_nve_dot.rst b/doc/src/fix_nve_dot.rst index 33d9f61b49..5fc6a46ab5 100644 --- a/doc/src/fix_nve_dot.rst +++ b/doc/src/fix_nve_dot.rst @@ -26,11 +26,11 @@ Examples Description """"""""""" -Apply a rigid-body integrator as described in :ref:`(Davidchack) ` +Apply a rigid-body integrator as described in :ref:`(Davidchack) ` to a group of atoms, but without Langevin dynamics. This command performs Molecular dynamics (MD) via a velocity-Verlet algorithm and an evolution operator that rotates -the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. +the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. This command is the equivalent of the :doc:`fix nve/dotc/langevin ` without damping and noise and can be used to determine the stability range @@ -40,7 +40,7 @@ The command is equivalent to the :doc:`fix nve `. The particles are always considered to have a finite size. An example input file can be found in /examples/USER/cgdna/examples/duplex1/. -Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -66,19 +66,15 @@ Related commands ---------- -.. _Davidchack1: - - - -.. _Miller1: +.. _Davidchack4: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, and M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). - -.. _Henrich3: +.. _Miller4: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). +.. _Henrich4: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). diff --git a/doc/src/fix_nve_dotc_langevin.rst b/doc/src/fix_nve_dotc_langevin.rst index 408aaf919e..3143db968f 100644 --- a/doc/src/fix_nve_dotc_langevin.rst +++ b/doc/src/fix_nve_dotc_langevin.rst @@ -38,14 +38,14 @@ Description """"""""""" Apply a rigid-body Langevin-type integrator of the kind "Langevin C" -as described in :ref:`(Davidchack) ` +as described in :ref:`(Davidchack) ` to a group of atoms, which models an interaction with an implicit background solvent. This command performs Brownian dynamics (BD) via a technique that splits the integration into a deterministic Hamiltonian part and the Ornstein-Uhlenbeck process for noise and damping. The quaternion degrees of freedom are updated though an evolution operator which performs a rotation in quaternion space, preserves -the quaternion norm and is akin to :ref:`(Miller) `. +the quaternion norm and is akin to :ref:`(Miller) `. In terms of syntax this command has been closely modelled on the :doc:`fix langevin ` and its *angmom* option. But it combines @@ -86,7 +86,7 @@ dt damp), where Kb is the Boltzmann constant, T is the desired temperature, m is the mass of the particle, dt is the timestep size, and damp is the damping factor. Random numbers are used to randomize the direction and magnitude of this force as described in -:ref:`(Dunweg) `, where a uniform random number is used (instead of +:ref:`(Dunweg) `, where a uniform random number is used (instead of a Gaussian random number) for speed. @@ -128,7 +128,7 @@ The scale factor after the *angmom* keyword gives the ratio of the rotational to the translational friction coefficient. An example input file can be found in /examples/USER/cgdna/examples/duplex2/. -Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -154,24 +154,19 @@ Related commands ---------- -.. _Davidchack2: - - - -.. _Miller2: +.. _Davidchack5: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). - -.. _Dunweg3: +.. _Miller5: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). - -.. _Henrich4: +.. _Dunweg5: **(Dunweg)** B. Dunweg, W. Paul, Int. J. Mod. Phys. C, 2, 817-27 (1991). +.. _Henrich5: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). diff --git a/doc/src/pair_oxdna.rst b/doc/src/pair_oxdna.rst index 727f19c327..b40cf1f6cc 100644 --- a/doc/src/pair_oxdna.rst +++ b/doc/src/pair_oxdna.rst @@ -36,8 +36,8 @@ Syntax *oxdna/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 = 1.3448 (temperature-independent coefficient in stacking strength) - kappa = 2.6568 (coefficient of linear temperature dependence in stacking strength) + 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) @@ -94,15 +94,11 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` in any publication that uses -this implementation. The article contains general information -on the model, its implementation and performance as well as the structure of -the data and input file. The preprint version of the article can be found -`here `_. -Please cite also the relevant oxDNA publications -:ref:`(Ouldridge) `, -:ref:`(Ouldridge-DPhil) ` -and :ref:`(Sulc) `. +Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. +The article contains more information on the model, the structure of the input file, the setup tool +and the performance of the LAMMPS-implementation of oxDNA. +The preprint version of the article can be found `here `_. + ---------- @@ -118,32 +114,39 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna/fene `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv `, -:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, -:doc:`fix nve/dotc/langevin ` - +:doc:`bond\_style oxdna/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv ` + **Default:** none ---------- + .. _Henrich1: + + **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Sulc1: + + + +**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + .. _Ouldridge-DPhil1: -**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). + + +**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge1: + + **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). -.. _Sulc1: - -**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). - .. _lws: http://lammps.sandia.gov .. _ld: Manual.html diff --git a/doc/src/pair_oxdna2.rst b/doc/src/pair_oxdna2.rst index 77052da666..4f64197f44 100644 --- a/doc/src/pair_oxdna2.rst +++ b/doc/src/pair_oxdna2.rst @@ -39,15 +39,15 @@ Syntax *oxdna2/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 = 1.3523 (temperature-independent coefficient in stacking strength) - kappa = 2.6717 (coefficient of linear temperature dependence in stacking strength) + 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 T = temperature (oxDNA units, 0.1 = 300 K) rhos = salt concentration (mole per litre) - qeff = 0.815 (effective charge in elementary charges) + qeff = effective charge (elementary charges) Examples """""""" @@ -63,7 +63,7 @@ Examples 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 0.1 0.5 0.815 + pair_coeff \* \* oxdna2/dh 0.1 1.0 0.815 Description """"""""""" @@ -83,7 +83,7 @@ The exact functional form of the pair styles is rather complex. The individual potentials consist of products of modulation factors, which themselves are constructed from a number of more basic potentials (Morse, Lennard-Jones, harmonic angle and distance) as well as quadratic smoothing and modulation terms. -We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` +We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 force field. .. note:: @@ -94,7 +94,7 @@ and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 fo in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. 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=0.5, qeff=0.815 in the above example). When using a Langevin thermostat + after *oxdna2/dh* (T=0.1, rhos=1.0, qeff=0.815 in the above example). When using a Langevin thermostat e.g. through :doc:`fix langevin ` or :doc:`fix nve/dotc/langevin ` the temperature coefficients have to be matched to the one used in the fix. @@ -102,13 +102,11 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` in any publication that uses -this implementation. The article contains general information -on the model, its implementation and performance as well as the structure of -the data and input file. The preprint version of the article can be found -`here `_. -Please cite also the relevant oxDNA2 publications -:ref:`(Snodin) ` and :ref:`(Sulc) `. +Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. +The article contains more information on the model, the structure of the input file, the setup tool +and the performance of the LAMMPS-implementation of oxDNA. +The preprint version of the article can be found `here `_. + ---------- @@ -124,34 +122,43 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna2/fene `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv `, -:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, -:doc:`fix nve/dotc/langevin ` +:doc:`bond\_style oxdna2/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv ` **Default:** none ---------- -.. _Henrich2: + +.. _Henrich: + + **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -.. _Snodin2: - -**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). - .. _Sulc2: + + **(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). +.. _Snodin: + + + +**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). + .. _Ouldridge-DPhil2: -**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). + + +**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge2: + + **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). From 4fa86e6ee833ba7c9964b2ddc5f40aeec191c673 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 21:59:21 +0000 Subject: [PATCH 443/557] Revert "Fixed anchor errors" This reverts commit 2d6e84edd74bcf23ce569d04a37561eb1c0f6204. --- doc/src/bond_oxdna.rst | 75 +++++++++++++++++++------------ doc/src/fix_nve_dot.rst | 16 ++++--- doc/src/fix_nve_dotc_langevin.rst | 21 +++++---- doc/src/pair_oxdna.rst | 45 +++++++++---------- doc/src/pair_oxdna2.rst | 55 ++++++++++------------- 5 files changed, 115 insertions(+), 97 deletions(-) diff --git a/doc/src/bond_oxdna.rst b/doc/src/bond_oxdna.rst index 51692f933b..36370ddf30 100644 --- a/doc/src/bond_oxdna.rst +++ b/doc/src/bond_oxdna.rst @@ -6,6 +6,9 @@ bond\_style oxdna/fene command bond\_style oxdna2/fene command =============================== +bond\_style oxrna2/fene command +=============================== + Syntax """""" @@ -16,6 +19,8 @@ Syntax bond_style oxdna2/fene + bond_style oxrna2/fene + Examples """""""" @@ -28,18 +33,21 @@ Examples bond_style oxdna2/fene bond_coeff \* 2.0 0.25 0.7564 + bond_style oxrna2/fene + bond_coeff \* 2.0 0.25 0.76107 + Description """"""""""" -The *oxdna/fene* and *oxdna2/fene* bond styles use the potential +The *oxdna/fene* , *oxdna2/fene* and *oxrna2/fene* bond styles use the potential .. image:: Eqs/bond_oxdna_fene.jpg :align: center to define a modified finite extensible nonlinear elastic (FENE) -potential :ref:`(Ouldridge) ` to model the connectivity of the -phosphate backbone in the oxDNA force field for coarse-grained -modelling of DNA. +potential :ref:`(Ouldridge) ` to model the connectivity of the +phosphate backbone in the oxDNA/oxRNA force field for coarse-grained +modelling of DNA/RNA. The following coefficients must be defined for the bond type via the :doc:`bond\_coeff ` command as given in the above example, or @@ -55,27 +63,36 @@ commands: The oxDNA bond style has to be used together with the corresponding oxDNA pair styles for excluded volume interaction - *oxdna/excv*\ , stacking *oxdna/stk*\ , cross-stacking *oxdna/xstk* and + *oxdna/excv* , stacking *oxdna/stk* , cross-stacking *oxdna/xstk* and coaxial stacking interaction *oxdna/coaxstk* as well as hydrogen-bonding interaction *oxdna/hbond* (see also documentation of :doc:`pair\_style oxdna/excv `). For the oxDNA2 - :ref:`(Snodin) ` bond style the analogous pair styles and an - additional Debye-Hueckel pair style *oxdna2/dh* have to be defined. + :ref:`(Snodin) ` bond style the analogous pair styles + *oxdna2/excv* , *oxdna2/stk* , *oxdna2/xstk* , *oxdna2/coaxstk* , + *oxdna2/hbond* and an additional Debye-Hueckel pair style + *oxdna2/dh* have to be defined. The same applies to the oxRNA2 + :ref:`(Sulc1) ` styles. The coefficients in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. -Example input and data files for DNA duplexes can be found in -examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. A simple python -setup tool which creates single straight or helical DNA strands, DNA -duplexes or arrays of DNA duplexes can be found in +Example input and data files for DNA and RNA duplexes can be found in +examples/USER/cgdna/examples/oxDNA/ , /oxDNA2/ and /oxRNA2/. A simple python +setup tool which creates single straight or helical DNA strands, DNA/RNA +duplexes or arrays of DNA/RNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in -any publication that uses this implementation. The article contains -more information on the model, the structure of the input file, the -setup tool and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found `here `_. +Please cite also the relevant oxDNA/oxRNA publications. These are +:ref:`(Ouldridge) ` and +:ref:`(Ouldridge-DPhil) ` for oxDNA, +:ref:`(Snodin) ` for oxDNA2, +:ref:`(Sulc1) ` for oxRNA2 +and for sequence-specific hydrogen-bonding and stacking interactions +:ref:`(Sulc2) `. ---------- @@ -92,35 +109,37 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`fix nve/dotc/langevin `, -:doc:`bond\_coeff ` +:doc:`pair\_style oxdna/excv `, :doc:`pair\_style oxdna2/excv `, :doc:`pair\_style oxrna2/excv `, +:doc:`bond\_coeff `, :doc:`fix nve/dotc/langevin ` **Default:** none ---------- +.. _Henrich0: -.. _Henrich2: +**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Ouldridge-DPhil0: +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). -**(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, -T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). +.. _Ouldridge0: -.. _oxdna\_fene: +**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). +.. _Snodin0: +**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). -**(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, -J. Chem. Phys. 134, 085101 (2011). +.. _Sulc01: -.. _oxdna2: +**(Sulc1)** P. Sulc, F. Romano, T. E. Ouldridge, et al., J. Chem. Phys. 140, 235102 (2014). +.. _Sulc02: - -**(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., -J. Chem. Phys. 142, 234901 (2015). +**(Sulc2)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). .. _lws: http://lammps.sandia.gov diff --git a/doc/src/fix_nve_dot.rst b/doc/src/fix_nve_dot.rst index 5fc6a46ab5..33d9f61b49 100644 --- a/doc/src/fix_nve_dot.rst +++ b/doc/src/fix_nve_dot.rst @@ -26,11 +26,11 @@ Examples Description """"""""""" -Apply a rigid-body integrator as described in :ref:`(Davidchack) ` +Apply a rigid-body integrator as described in :ref:`(Davidchack) ` to a group of atoms, but without Langevin dynamics. This command performs Molecular dynamics (MD) via a velocity-Verlet algorithm and an evolution operator that rotates -the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. +the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. This command is the equivalent of the :doc:`fix nve/dotc/langevin ` without damping and noise and can be used to determine the stability range @@ -40,7 +40,7 @@ The command is equivalent to the :doc:`fix nve `. The particles are always considered to have a finite size. An example input file can be found in /examples/USER/cgdna/examples/duplex1/. -Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -66,15 +66,19 @@ Related commands ---------- -.. _Davidchack4: +.. _Davidchack1: + + + +.. _Miller1: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, and M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). -.. _Miller4: + +.. _Henrich3: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). -.. _Henrich4: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). diff --git a/doc/src/fix_nve_dotc_langevin.rst b/doc/src/fix_nve_dotc_langevin.rst index 3143db968f..408aaf919e 100644 --- a/doc/src/fix_nve_dotc_langevin.rst +++ b/doc/src/fix_nve_dotc_langevin.rst @@ -38,14 +38,14 @@ Description """"""""""" Apply a rigid-body Langevin-type integrator of the kind "Langevin C" -as described in :ref:`(Davidchack) ` +as described in :ref:`(Davidchack) ` to a group of atoms, which models an interaction with an implicit background solvent. This command performs Brownian dynamics (BD) via a technique that splits the integration into a deterministic Hamiltonian part and the Ornstein-Uhlenbeck process for noise and damping. The quaternion degrees of freedom are updated though an evolution operator which performs a rotation in quaternion space, preserves -the quaternion norm and is akin to :ref:`(Miller) `. +the quaternion norm and is akin to :ref:`(Miller) `. In terms of syntax this command has been closely modelled on the :doc:`fix langevin ` and its *angmom* option. But it combines @@ -86,7 +86,7 @@ dt damp), where Kb is the Boltzmann constant, T is the desired temperature, m is the mass of the particle, dt is the timestep size, and damp is the damping factor. Random numbers are used to randomize the direction and magnitude of this force as described in -:ref:`(Dunweg) `, where a uniform random number is used (instead of +:ref:`(Dunweg) `, where a uniform random number is used (instead of a Gaussian random number) for speed. @@ -128,7 +128,7 @@ The scale factor after the *angmom* keyword gives the ratio of the rotational to the translational friction coefficient. An example input file can be found in /examples/USER/cgdna/examples/duplex2/. -Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -154,19 +154,24 @@ Related commands ---------- -.. _Davidchack5: +.. _Davidchack2: + + + +.. _Miller2: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). -.. _Miller5: + +.. _Dunweg3: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). -.. _Dunweg5: + +.. _Henrich4: **(Dunweg)** B. Dunweg, W. Paul, Int. J. Mod. Phys. C, 2, 817-27 (1991). -.. _Henrich5: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). diff --git a/doc/src/pair_oxdna.rst b/doc/src/pair_oxdna.rst index b40cf1f6cc..727f19c327 100644 --- a/doc/src/pair_oxdna.rst +++ b/doc/src/pair_oxdna.rst @@ -36,8 +36,8 @@ Syntax *oxdna/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 + xi = 1.3448 (temperature-independent coefficient in stacking strength) + kappa = 2.6568 (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) @@ -94,11 +94,15 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. -The article contains more information on the model, the structure of the input file, the setup tool -and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found `here `_. - +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found +`here `_. +Please cite also the relevant oxDNA publications +:ref:`(Ouldridge) `, +:ref:`(Ouldridge-DPhil) ` +and :ref:`(Sulc) `. ---------- @@ -114,39 +118,32 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv ` - +:doc:`bond\_style oxdna/fene `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_style oxdna2/excv `, +:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, +:doc:`fix nve/dotc/langevin ` + **Default:** none ---------- - .. _Henrich1: - - **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -.. _Sulc1: - - - -**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). - .. _Ouldridge-DPhil1: - - -**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge1: - - **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). +.. _Sulc1: + +**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + .. _lws: http://lammps.sandia.gov .. _ld: Manual.html diff --git a/doc/src/pair_oxdna2.rst b/doc/src/pair_oxdna2.rst index 4f64197f44..77052da666 100644 --- a/doc/src/pair_oxdna2.rst +++ b/doc/src/pair_oxdna2.rst @@ -39,15 +39,15 @@ Syntax *oxdna2/stk* args = seq T xi kappa 6.0 0.4 0.9 0.32 0.75 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 + xi = 1.3523 (temperature-independent coefficient in stacking strength) + kappa = 2.6717 (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 T = temperature (oxDNA units, 0.1 = 300 K) rhos = salt concentration (mole per litre) - qeff = effective charge (elementary charges) + qeff = 0.815 (effective charge in elementary charges) Examples """""""" @@ -63,7 +63,7 @@ Examples 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 0.1 1.0 0.815 + pair_coeff \* \* oxdna2/dh 0.1 0.5 0.815 Description """"""""""" @@ -83,7 +83,7 @@ The exact functional form of the pair styles is rather complex. The individual potentials consist of products of modulation factors, which themselves are constructed from a number of more basic potentials (Morse, Lennard-Jones, harmonic angle and distance) as well as quadratic smoothing and modulation terms. -We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` +We refer to :ref:`(Snodin) ` and the original oxDNA publications :ref:`(Ouldridge-DPhil) ` and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 force field. .. note:: @@ -94,7 +94,7 @@ and :ref:`(Ouldridge) ` for a detailed description of the oxDNA2 fo in the above example have to be kept fixed and cannot be changed without reparameterizing the entire model. 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 + after *oxdna2/dh* (T=0.1, rhos=0.5, qeff=0.815 in the above example). When using a Langevin thermostat e.g. through :doc:`fix langevin ` or :doc:`fix nve/dotc/langevin ` the temperature coefficients have to be matched to the one used in the fix. @@ -102,11 +102,13 @@ Example input and data files for DNA duplexes can be found in examples/USER/cgdn A simple python setup tool which creates single straight or helical DNA strands, DNA duplexes or arrays of DNA duplexes can be found in examples/USER/cgdna/util/. -Please cite :ref:`(Henrich) ` and the relevant oxDNA articles in any publication that uses this implementation. -The article contains more information on the model, the structure of the input file, the setup tool -and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found `here `_. - +Please cite :ref:`(Henrich) ` in any publication that uses +this implementation. The article contains general information +on the model, its implementation and performance as well as the structure of +the data and input file. The preprint version of the article can be found +`here `_. +Please cite also the relevant oxDNA2 publications +:ref:`(Snodin) ` and :ref:`(Sulc) `. ---------- @@ -122,43 +124,34 @@ USER-CGDNA package and the MOLECULE and ASPHERE package. See the Related commands """""""""""""""" -:doc:`bond\_style oxdna2/fene `, :doc:`fix nve/dotc/langevin `, :doc:`pair\_coeff `, -:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv ` +:doc:`bond\_style oxdna2/fene `, :doc:`pair\_coeff `, +:doc:`bond\_style oxdna/fene `, :doc:`pair\_style oxdna/excv `, +:doc:`bond\_style oxrna2/fene `, :doc:`pair\_style oxrna2/excv `, +:doc:`fix nve/dotc/langevin ` **Default:** none ---------- - -.. _Henrich: - - +.. _Henrich2: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). -.. _Sulc2: - - - -**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). - -.. _Snodin: - - +.. _Snodin2: **(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). +.. _Sulc2: + +**(Sulc)** P. Sulc, F. Romano, T.E. Ouldridge, L. Rovigatti, J.P.K. Doye, A.A. Louis, J. Chem. Phys. 137, 135101 (2012). + .. _Ouldridge-DPhil2: - - -**(Ouldrigde-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). +**(Ouldridge-DPhil)** T.E. Ouldridge, Coarse-grained modelling of DNA and DNA self-assembly, DPhil. University of Oxford (2011). .. _Ouldridge2: - - **(Ouldridge)** T.E. Ouldridge, A.A. Louis, J.P.K. Doye, J. Chem. Phys. 134, 085101 (2011). From 06c7464a20b6ceaefb01da2b77372b7618072643 Mon Sep 17 00:00:00 2001 From: Oliver Henrich Date: Fri, 15 Nov 2019 22:05:12 +0000 Subject: [PATCH 444/557] Fixed anchor error --- doc/src/fix_nve_dot.rst | 16 ++++++---------- doc/src/fix_nve_dotc_langevin.rst | 21 ++++++++------------- 2 files changed, 14 insertions(+), 23 deletions(-) diff --git a/doc/src/fix_nve_dot.rst b/doc/src/fix_nve_dot.rst index 33d9f61b49..5fc6a46ab5 100644 --- a/doc/src/fix_nve_dot.rst +++ b/doc/src/fix_nve_dot.rst @@ -26,11 +26,11 @@ Examples Description """"""""""" -Apply a rigid-body integrator as described in :ref:`(Davidchack) ` +Apply a rigid-body integrator as described in :ref:`(Davidchack) ` to a group of atoms, but without Langevin dynamics. This command performs Molecular dynamics (MD) via a velocity-Verlet algorithm and an evolution operator that rotates -the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. +the quaternion degrees of freedom, similar to the scheme outlined in :ref:`(Miller) `. This command is the equivalent of the :doc:`fix nve/dotc/langevin ` without damping and noise and can be used to determine the stability range @@ -40,7 +40,7 @@ The command is equivalent to the :doc:`fix nve `. The particles are always considered to have a finite size. An example input file can be found in /examples/USER/cgdna/examples/duplex1/. -Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrator are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -66,19 +66,15 @@ Related commands ---------- -.. _Davidchack1: - - - -.. _Miller1: +.. _Davidchack4: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, and M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). - -.. _Henrich3: +.. _Miller4: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). +.. _Henrich4: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). diff --git a/doc/src/fix_nve_dotc_langevin.rst b/doc/src/fix_nve_dotc_langevin.rst index 408aaf919e..3143db968f 100644 --- a/doc/src/fix_nve_dotc_langevin.rst +++ b/doc/src/fix_nve_dotc_langevin.rst @@ -38,14 +38,14 @@ Description """"""""""" Apply a rigid-body Langevin-type integrator of the kind "Langevin C" -as described in :ref:`(Davidchack) ` +as described in :ref:`(Davidchack) ` to a group of atoms, which models an interaction with an implicit background solvent. This command performs Brownian dynamics (BD) via a technique that splits the integration into a deterministic Hamiltonian part and the Ornstein-Uhlenbeck process for noise and damping. The quaternion degrees of freedom are updated though an evolution operator which performs a rotation in quaternion space, preserves -the quaternion norm and is akin to :ref:`(Miller) `. +the quaternion norm and is akin to :ref:`(Miller) `. In terms of syntax this command has been closely modelled on the :doc:`fix langevin ` and its *angmom* option. But it combines @@ -86,7 +86,7 @@ dt damp), where Kb is the Boltzmann constant, T is the desired temperature, m is the mass of the particle, dt is the timestep size, and damp is the damping factor. Random numbers are used to randomize the direction and magnitude of this force as described in -:ref:`(Dunweg) `, where a uniform random number is used (instead of +:ref:`(Dunweg) `, where a uniform random number is used (instead of a Gaussian random number) for speed. @@ -128,7 +128,7 @@ The scale factor after the *angmom* keyword gives the ratio of the rotational to the translational friction coefficient. An example input file can be found in /examples/USER/cgdna/examples/duplex2/. -Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. +Further details of the implementation and stability of the integrators are contained in :ref:`(Henrich) `. The preprint version of the article can be found `here `_. @@ -154,24 +154,19 @@ Related commands ---------- -.. _Davidchack2: - - - -.. _Miller2: +.. _Davidchack5: **(Davidchack)** R.L Davidchack, T.E. Ouldridge, M.V. Tretyakov. J. Chem. Phys. 142, 144114 (2015). - -.. _Dunweg3: +.. _Miller5: **(Miller)** T. F. Miller III, M. Eleftheriou, P. Pattnaik, A. Ndirango, G. J. Martyna, J. Chem. Phys., 116, 8649-8659 (2002). - -.. _Henrich4: +.. _Dunweg5: **(Dunweg)** B. Dunweg, W. Paul, Int. J. Mod. Phys. C, 2, 817-27 (1991). +.. _Henrich5: **(Henrich)** O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). From 9a43229c83b39c2777053e1d2c6092d6607ac7ca Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 15 Nov 2019 19:48:58 -0500 Subject: [PATCH 445/557] disable single function for KOKKOS eam styles, since the required data is not available --- src/KOKKOS/pair_eam_kokkos.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/KOKKOS/pair_eam_kokkos.cpp b/src/KOKKOS/pair_eam_kokkos.cpp index f6eef5b53c..3358fe709c 100644 --- a/src/KOKKOS/pair_eam_kokkos.cpp +++ b/src/KOKKOS/pair_eam_kokkos.cpp @@ -37,6 +37,7 @@ template PairEAMKokkos::PairEAMKokkos(LAMMPS *lmp) : PairEAM(lmp) { respa_enable = 0; + single_enable = 0; atomKK = (AtomKokkos *) atom; execution_space = ExecutionSpaceFromDevice::space; From 48894884124e319a89003741d967af422484c625 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Fri, 15 Nov 2019 19:49:30 -0500 Subject: [PATCH 446/557] rename count_embed to numforce and move the location where numforce is set to 0 --- src/MANYBODY/pair_eam.cpp | 16 ++++++++-------- src/MANYBODY/pair_eam.h | 2 +- src/OPT/pair_eam_opt.cpp | 8 ++++---- src/USER-OMP/pair_eam_omp.cpp | 8 ++++---- 4 files changed, 17 insertions(+), 17 deletions(-) diff --git a/src/MANYBODY/pair_eam.cpp b/src/MANYBODY/pair_eam.cpp index 8913b1e9cc..5459a92b69 100644 --- a/src/MANYBODY/pair_eam.cpp +++ b/src/MANYBODY/pair_eam.cpp @@ -43,7 +43,7 @@ PairEAM::PairEAM(LAMMPS *lmp) : Pair(lmp) nmax = 0; rho = NULL; fp = NULL; - count_embed = NULL; + numforce = NULL; map = NULL; type2frho = NULL; @@ -78,7 +78,7 @@ PairEAM::~PairEAM() memory->destroy(rho); memory->destroy(fp); - memory->destroy(count_embed); + memory->destroy(numforce); if (allocated) { memory->destroy(setflag); @@ -153,11 +153,11 @@ void PairEAM::compute(int eflag, int vflag) if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); - memory->destroy(count_embed); + memory->destroy(numforce); nmax = atom->nmax; memory->create(rho,nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); - memory->create(count_embed,nmax,"pair:count_embed"); + memory->create(numforce,nmax,"pair:numforce"); } double **x = atom->x; @@ -234,7 +234,6 @@ void PairEAM::compute(int eflag, int vflag) p = MIN(p,1.0); coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; - count_embed[i] = 0; if (eflag) { phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -260,6 +259,7 @@ void PairEAM::compute(int eflag, int vflag) jlist = firstneigh[i]; jnum = numneigh[i]; + numforce[i] = 0; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; @@ -271,7 +271,7 @@ void PairEAM::compute(int eflag, int vflag) rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutforcesq) { - ++count_embed[i]; + ++numforce[i]; jtype = type[j]; r = sqrt(rsq); p = r*rdr + 1.0; @@ -808,7 +808,7 @@ double PairEAM::single(int i, int j, int itype, int jtype, double r,p,rhoip,rhojp,z2,z2p,recip,phi,phip,psip; double *coeff; - if (count_embed[i] > 0) { + if (numforce[i] > 0) { p = rho[i]*rdrho + 1.0; m = static_cast (p); m = MAX(1,MIN(m,nrho-1)); @@ -817,7 +817,7 @@ double PairEAM::single(int i, int j, int itype, int jtype, coeff = frho_spline[type2frho[itype]][m]; phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); - phi *= 1.0/static_cast(count_embed[i]); + phi *= 1.0/static_cast(numforce[i]); } else phi = 0.0; r = sqrt(rsq); diff --git a/src/MANYBODY/pair_eam.h b/src/MANYBODY/pair_eam.h index 3f135aaa1f..add33ab3f0 100644 --- a/src/MANYBODY/pair_eam.h +++ b/src/MANYBODY/pair_eam.h @@ -70,7 +70,7 @@ class PairEAM : public Pair { // per-atom arrays double *rho,*fp; - int *count_embed; + int *numforce; // potentials as file data diff --git a/src/OPT/pair_eam_opt.cpp b/src/OPT/pair_eam_opt.cpp index dbea720488..7dff5cff4b 100644 --- a/src/OPT/pair_eam_opt.cpp +++ b/src/OPT/pair_eam_opt.cpp @@ -82,11 +82,11 @@ void PairEAMOpt::eval() if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); - memory->destroy(count_embed); + memory->destroy(numforce); nmax = atom->nmax; memory->create(rho,nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); - memory->create(count_embed,nmax,"pair:count_embed"); + memory->create(numforce,nmax,"pair:numforce"); } double** _noalias x = atom->x; @@ -240,7 +240,6 @@ void PairEAMOpt::eval() ++m; coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; - count_embed[i] = 0; if (EFLAG) { double phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -272,6 +271,7 @@ void PairEAMOpt::eval() fast_gamma_t* _noalias tabssi = &tabss[itype1*ntypes*nr]; double* _noalias scale_i = scale[itype1+1]+1; + numforce[i] = 0; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; @@ -283,7 +283,7 @@ void PairEAMOpt::eval() double rsq = delx*delx + dely*dely + delz*delz; if (rsq < tmp_cutforcesq) { - ++count_embed[i]; + ++numforce[i]; jtype = type[j] - 1; double r = sqrt(rsq); double rhoip,rhojp,z2,z2p; diff --git a/src/USER-OMP/pair_eam_omp.cpp b/src/USER-OMP/pair_eam_omp.cpp index 1b48214ed4..3b0bb54065 100644 --- a/src/USER-OMP/pair_eam_omp.cpp +++ b/src/USER-OMP/pair_eam_omp.cpp @@ -51,11 +51,11 @@ void PairEAMOMP::compute(int eflag, int vflag) if (atom->nmax > nmax) { memory->destroy(rho); memory->destroy(fp); - memory->destroy(count_embed); + memory->destroy(numforce); nmax = atom->nmax; memory->create(rho,nthreads*nmax,"pair:rho"); memory->create(fp,nmax,"pair:fp"); - memory->create(count_embed,nmax,"pair:count_embed"); + memory->create(numforce,nmax,"pair:numforce"); } #if defined(_OPENMP) @@ -200,7 +200,6 @@ void PairEAMOMP::eval(int iifrom, int iito, ThrData * const thr) p = MIN(p,1.0); coeff = frho_spline[type2frho[type[i]]][m]; fp[i] = (coeff[0]*p + coeff[1])*p + coeff[2]; - count_embed[i] = 0; if (EFLAG) { phi = ((coeff[3]*p + coeff[4])*p + coeff[5])*p + coeff[6]; if (rho[i] > rhomax) phi += fp[i] * (rho[i]-rhomax); @@ -235,6 +234,7 @@ void PairEAMOMP::eval(int iifrom, int iito, ThrData * const thr) jlist = firstneigh[i]; jnum = numneigh[i]; + numforce[i] = 0; for (jj = 0; jj < jnum; jj++) { j = jlist[jj]; @@ -246,7 +246,7 @@ void PairEAMOMP::eval(int iifrom, int iito, ThrData * const thr) rsq = delx*delx + dely*dely + delz*delz; if (rsq < cutforcesq) { - ++count_embed[i]; + ++numforce[i]; jtype = type[j]; r = sqrt(rsq); p = r*rdr + 1.0; From 58bbbc3d8b3e68c0fab028e9dace05d218af491b Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 15 Nov 2019 18:00:25 -0700 Subject: [PATCH 447/557] Started on ComputeSnap --- src/SNAP/compute_snap.cpp | 377 ++++++++++++++++++++++++++++++++++++++ src/SNAP/compute_snap.h | 77 ++++++++ 2 files changed, 454 insertions(+) create mode 100644 src/SNAP/compute_snap.cpp create mode 100644 src/SNAP/compute_snap.h diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp new file mode 100644 index 0000000000..31b50e1902 --- /dev/null +++ b/src/SNAP/compute_snap.cpp @@ -0,0 +1,377 @@ +/* ---------------------------------------------------------------------- + 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 "compute_snap.h" +#include +#include +#include "sna.h" +#include "atom.h" +#include "update.h" +#include "modify.h" +#include "neighbor.h" +#include "neigh_list.h" +#include "neigh_request.h" +#include "force.h" +#include "pair.h" +#include "comm.h" +#include "memory.h" +#include "error.h" + +using namespace LAMMPS_NS; + +ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : + Compute(lmp, narg, arg), cutsq(NULL), list(NULL), snap(NULL), + radelem(NULL), wjelem(NULL) +{ + double rfac0, rmin0; + int twojmax, switchflag, bzeroflag; + radelem = NULL; + wjelem = NULL; + + int ntypes = atom->ntypes; + int nargmin = 6+2*ntypes; + + if (narg < nargmin) error->all(FLERR,"Illegal compute snap command"); + + // default values + + rmin0 = 0.0; + switchflag = 1; + bzeroflag = 1; + quadraticflag = 0; + + // process required arguments + + memory->create(radelem,ntypes+1,"snap:radelem"); // offset by 1 to match up with types + memory->create(wjelem,ntypes+1,"snap:wjelem"); + rcutfac = atof(arg[3]); + rfac0 = atof(arg[4]); + twojmax = atoi(arg[5]); + for(int i = 0; i < ntypes; i++) + radelem[i+1] = atof(arg[6+i]); + for(int i = 0; i < ntypes; i++) + wjelem[i+1] = atof(arg[6+ntypes+i]); + + // construct cutsq + + double cut; + cutmax = 0.0; + memory->create(cutsq,ntypes+1,ntypes+1,"snap:cutsq"); + for(int i = 1; i <= ntypes; i++) { + cut = 2.0*radelem[i]*rcutfac; + if (cut > cutmax) cutmax = cut; + cutsq[i][i] = cut*cut; + for(int j = i+1; j <= ntypes; j++) { + cut = (radelem[i]+radelem[j])*rcutfac; + cutsq[i][j] = cutsq[j][i] = cut*cut; + } + } + + // process optional args + + int iarg = nargmin; + + while (iarg < narg) { + if (strcmp(arg[iarg],"rmin0") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + rmin0 = atof(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"bzeroflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + bzeroflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"switchflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + switchflag = atoi(arg[iarg+1]); + iarg += 2; + } else if (strcmp(arg[iarg],"quadraticflag") == 0) { + if (iarg+2 > narg) + error->all(FLERR,"Illegal compute snap command"); + quadraticflag = atoi(arg[iarg+1]); + iarg += 2; + } else error->all(FLERR,"Illegal compute snap command"); + } + + snaptr = new SNA(lmp,rfac0,twojmax, + rmin0,switchflag,bzeroflag); + + ncoeff = snaptr->ncoeff; + nperdim = ncoeff; + if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; + yoffset = nperdim; + zoffset = 2*nperdim; + size_peratom_cols = 3*nperdim*atom->ntypes; + comm_reverse = size_peratom_cols; + + nmax = 0; + snap = NULL; +} + +/* ---------------------------------------------------------------------- */ + +ComputeSnap::~ComputeSnap() +{ + memory->destroy(snap); + memory->destroy(radelem); + memory->destroy(wjelem); + memory->destroy(cutsq); + delete snaptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::init() +{ + if (force->pair == NULL) + error->all(FLERR,"Compute snap requires a pair style be defined"); + + if (cutmax > force->pair->cutforce) + error->all(FLERR,"Compute snap cutoff is longer than pairwise cutoff"); + + // need an occasional full neighbor list + + int irequest = neighbor->request(this,instance_me); + neighbor->requests[irequest]->pair = 0; + neighbor->requests[irequest]->compute = 1; + neighbor->requests[irequest]->half = 0; + neighbor->requests[irequest]->full = 1; + neighbor->requests[irequest]->occasional = 1; + + int count = 0; + for (int i = 0; i < modify->ncompute; i++) + if (strcmp(modify->compute[i]->style,"snap") == 0) count++; + if (count > 1 && comm->me == 0) + error->warning(FLERR,"More than one compute snap"); + snaptr->init(); +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::init_list(int /*id*/, NeighList *ptr) +{ + list = ptr; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::compute() +{ + int ntotal = atom->nlocal + atom->nghost; + + invoked_peratom = update->ntimestep; + + // grow snap array if necessary + + if (atom->nmax > nmax) { + memory->destroy(snap); + nmax = atom->nmax; + memory->create(snap,nmax,size_peratom_cols, + "snap:snap"); + array = snap; + } + + // clear local array + + for (int i = 0; i < ntotal; i++) + for (int icoeff = 0; icoeff < size_peratom_cols; icoeff++) { + snap[i][icoeff] = 0.0; + } + + // invoke full neighbor list (will copy or build if necessary) + + neighbor->build_one(list); + + const int inum = list->inum; + const int* const ilist = list->ilist; + const int* const numneigh = list->numneigh; + int** const firstneigh = list->firstneigh; + int * const type = atom->type; + + // compute sna derivatives for each atom in group + // use full neighbor list to count atoms less than cutoff + + double** const x = atom->x; + const int* const mask = atom->mask; + + for (int ii = 0; ii < inum; ii++) { + const int i = ilist[ii]; + if (mask[i] & groupbit) { + + const double xtmp = x[i][0]; + const double ytmp = x[i][1]; + const double ztmp = x[i][2]; + const int itype = type[i]; + const double radi = radelem[itype]; + const int* const jlist = firstneigh[i]; + const int jnum = numneigh[i]; + + // const int typeoffset = threencoeff*(atom->type[i]-1); + // const int quadraticoffset = threencoeff*atom->ntypes + + // threencoeffq*(atom->type[i]-1); + const int typeoffset = 3*nperdim*(atom->type[i]-1); + + // insure rij, inside, and typej are of size jnum + + snaptr->grow_rij(jnum); + + // rij[][3] = displacements between atom I and those neighbors + // inside = indices of neighbors of I within cutoff + // typej = types of neighbors of I within cutoff + // note Rij sign convention => dU/dRij = dU/dRj = -dU/dRi + + int ninside = 0; + for (int jj = 0; jj < jnum; jj++) { + int j = jlist[jj]; + j &= NEIGHMASK; + + const double delx = x[j][0] - xtmp; + const double dely = x[j][1] - ytmp; + const double delz = x[j][2] - ztmp; + const double rsq = delx*delx + dely*dely + delz*delz; + int jtype = type[j]; + if (rsq < cutsq[itype][jtype]&&rsq>1e-20) { + snaptr->rij[ninside][0] = delx; + snaptr->rij[ninside][1] = dely; + snaptr->rij[ninside][2] = delz; + snaptr->inside[ninside] = j; + snaptr->wj[ninside] = wjelem[jtype]; + snaptr->rcutij[ninside] = (radi+radelem[jtype])*rcutfac; + ninside++; + } + } + + snaptr->compute_ui(ninside); + snaptr->compute_zi(); + if (quadraticflag) { + snaptr->compute_bi(); + } + + for (int jj = 0; jj < ninside; jj++) { + const int j = snaptr->inside[jj]; + snaptr->compute_duidrj(snaptr->rij[jj], + snaptr->wj[jj], + snaptr->rcutij[jj],jj); + snaptr->compute_dbidrj(); + + // Accumulate -dBi/dRi, -dBi/dRj + + double *snapi = snap[i]+typeoffset; + double *snapj = snap[j]+typeoffset; + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + snapi[icoeff] += snaptr->dblist[icoeff][0]; + snapi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snapi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snapj[icoeff] -= snaptr->dblist[icoeff][0]; + snapj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snapj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + } + + if (quadraticflag) { + const int quadraticoffset = ncoeff; + snapi += quadraticoffset; + snapj += quadraticoffset; + int ncount = 0; + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bi = snaptr->blist[icoeff]; + double bix = snaptr->dblist[icoeff][0]; + double biy = snaptr->dblist[icoeff][1]; + double biz = snaptr->dblist[icoeff][2]; + + // diagonal elements of quadratic matrix + + double dbxtmp = bi*bix; + double dbytmp = bi*biy; + double dbztmp = bi*biz; + + snapi[ncount] += dbxtmp; + snapi[ncount+yoffset] += dbytmp; + snapi[ncount+zoffset] += dbztmp; + snapj[ncount] -= dbxtmp; + snapj[ncount+yoffset] -= dbytmp; + snapj[ncount+zoffset] -= dbztmp; + ncount++; + + // upper-triangular elements of quadratic matrix + + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double dbxtmp = bi*snaptr->dblist[jcoeff][0] + + bix*snaptr->blist[jcoeff]; + double dbytmp = bi*snaptr->dblist[jcoeff][1] + + biy*snaptr->blist[jcoeff]; + double dbztmp = bi*snaptr->dblist[jcoeff][2] + + biz*snaptr->blist[jcoeff]; + + snapi[ncount] += dbxtmp; + snapi[ncount+yoffset] += dbytmp; + snapi[ncount+zoffset] += dbztmp; + snapj[ncount] -= dbxtmp; + snapj[ncount+yoffset] -= dbytmp; + snapj[ncount+zoffset] -= dbztmp; + ncount++; + } + } + } + } + } + } + + // communicate snap contributions between neighbor procs + + comm->reverse_comm_compute(this); + +} + +/* ---------------------------------------------------------------------- */ + +int ComputeSnap::pack_reverse_comm(int n, int first, double *buf) +{ + int i,m,last,icoeff; + + m = 0; + last = first + n; + for (i = first; i < last; i++) + for (icoeff = 0; icoeff < size_peratom_cols; icoeff++) + buf[m++] = snap[i][icoeff]; + return m; +} + +/* ---------------------------------------------------------------------- */ + +void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) +{ + int i,j,m,icoeff; + + m = 0; + for (i = 0; i < n; i++) { + j = list[i]; + for (icoeff = 0; icoeff < size_peratom_cols; icoeff++) + snap[j][icoeff] += buf[m++]; + } +} + +/* ---------------------------------------------------------------------- + memory usage +------------------------------------------------------------------------- */ + +double ComputeSnap::memory_usage() +{ + + double bytes = nmax*size_peratom_cols * sizeof(double); // snap + bytes += snaptr->memory_usage(); // SNA object + + return bytes; +} diff --git a/src/SNAP/compute_snap.h b/src/SNAP/compute_snap.h new file mode 100644 index 0000000000..9fa998981a --- /dev/null +++ b/src/SNAP/compute_snap.h @@ -0,0 +1,77 @@ +/* -*- 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(snap,ComputeSnap) + +#else + +#ifndef LMP_COMPUTE_SNAP_H +#define LMP_COMPUTE_SNAP_H + +#include "compute.h" + +namespace LAMMPS_NS { + +class ComputeSnap : public Compute { + public: + ComputeSnap(class LAMMPS *, int, char **); + ~ComputeSnap(); + void init(); + void init_list(int, class NeighList *); + void compute(); + int pack_reverse_comm(int, int, double *); + void unpack_reverse_comm(int, int *, double *); + double memory_usage(); + + private: + int nmax; + int ncoeff, nperdim, yoffset, zoffset; + double **cutsq; + class NeighList *list; + double **snap; + double rcutfac; + double *radelem; + double *wjelem; + class SNA* snaptr; + double cutmax; + int quadraticflag; +}; + +} + +#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: Compute snap requires a pair style be defined + +Self-explanatory. + +E: Compute snap cutoff is longer than pairwise cutoff + +UNDOCUMENTED + +W: More than one compute snad/atom + +Self-explanatory. + +*/ From ffc443c957644acc463a8c0d332af22bd653f778 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Fri, 15 Nov 2019 18:34:44 -0700 Subject: [PATCH 448/557] Started on ComputeSnap --- src/SNAP/compute_snap.cpp | 15 +++++++++++++-- 1 file changed, 13 insertions(+), 2 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 31b50e1902..c636ee8841 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -10,7 +10,17 @@ See the README file in the top-level LAMMPS directory. ------------------------------------------------------------------------- */ +/* IDEAS +-Need to define a local array for snad on local and ghost atoms, in addition +a local vector of (1+6)*size_array_cols scalars. +-Reverse communicate local array +-MPI Allreduce on vector +-Copy vector and array into output array +-size_array_cols = ncoeff +-size_array_rows = total number of atoms +-Boom! + */ #include "compute_snap.h" #include #include @@ -113,7 +123,8 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; yoffset = nperdim; zoffset = 2*nperdim; - size_peratom_cols = 3*nperdim*atom->ntypes; + size_array_rows = total number of atoms + size_array_cols = 3*nperdim*atom->ntypes; comm_reverse = size_peratom_cols; nmax = 0; @@ -178,7 +189,7 @@ void ComputeSnap::compute() if (atom->nmax > nmax) { memory->destroy(snap); nmax = atom->nmax; - memory->create(snap,nmax,size_peratom_cols, + memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); array = snap; } From 4b6265ae40867f35291c99cde3de1fff946b13ff Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 18:40:26 -0500 Subject: [PATCH 449/557] Update docs: atom_modify --- doc/src/atom_modify.rst | 15 ++-- doc/txt/atom_modify.txt | 175 ---------------------------------------- 2 files changed, 5 insertions(+), 185 deletions(-) delete mode 100644 doc/txt/atom_modify.txt diff --git a/doc/src/atom_modify.rst b/doc/src/atom_modify.rst index ad19f236c1..ac2720d4f2 100644 --- a/doc/src/atom_modify.rst +++ b/doc/src/atom_modify.rst @@ -1,13 +1,13 @@ -.. index:: atom\_modify +.. index:: atom_modify -atom\_modify command -==================== +atom_modify command +=================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS atom_modify keyword values ... @@ -29,7 +29,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS atom_modify map yes atom_modify map hash sort 10000 2.0 @@ -188,8 +188,3 @@ defined, sorting will be turned off. **(Meloni)** Meloni, Rosati and Colombo, J Chem Phys, 126, 121102 (2007). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/atom_modify.txt b/doc/txt/atom_modify.txt deleted file mode 100644 index d598b4697c..0000000000 --- a/doc/txt/atom_modify.txt +++ /dev/null @@ -1,175 +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 - -atom_modify command :h3 - -[Syntax:] - -atom_modify keyword values ... :pre - -one or more keyword/value pairs may be appended :ulb,l -keyword = {id} or {map} or {first} or {sort} :l - {id} value = {yes} or {no} - {map} value = {yes} or {array} or {hash} - {first} value = group-ID = group whose atoms will appear first in internal atom lists - {sort} values = Nfreq binsize - Nfreq = sort atoms spatially every this many time steps - binsize = bin size for spatial sorting (distance units) :pre -:ule - -[Examples:] - -atom_modify map yes -atom_modify map hash sort 10000 2.0 -atom_modify first colloid :pre - -[Description:] - -Modify certain attributes of atoms defined and stored within LAMMPS, -in addition to what is specified by the "atom_style"_atom_style.html -command. The {id} and {map} keywords must be specified before a -simulation box is defined; other keywords can be specified any time. - -The {id} keyword determines whether non-zero atom IDs can be assigned -to each atom. If the value is {yes}, which is the default, IDs are -assigned, whether you use the "create atoms"_create_atoms.html or -"read_data"_read_data.html or "read_restart"_read_restart.html -commands to initialize atoms. If the value is {no} the IDs for all -atoms are assumed to be 0. - -If atom IDs are used, they must all be positive integers. They should -also be unique, though LAMMPS does not check for this. Typically they -should also be consecutively numbered (from 1 to Natoms), though this -is not required. Molecular "atom styles"_atom_style.html are those -that store bond topology information (styles bond, angle, molecular, -full). These styles require atom IDs since the IDs are used to encode -the topology. Some other LAMMPS commands also require the use of atom -IDs. E.g. some many-body pair styles use them to avoid double -computation of the I-J interaction between two atoms. - -The only reason not to use atom IDs is if you are running an atomic -simulation so large that IDs cannot be uniquely assigned. For a -default LAMMPS build this limit is 2^31 or about 2 billion atoms. -However, even in this case, you can use 64-bit atom IDs, allowing 2^63 -or about 9e18 atoms, if you build LAMMPS with the - DLAMMPS_BIGBIG -switch. This is described on the "Build_settings"_Build_settings.html -doc page. If atom IDs are not used, they must be specified as 0 for -all atoms, e.g. in a data or restart file. - -The {map} keyword determines how atoms with specific IDs are found -when required. An example are the bond (angle, etc) methods which -need to find the local index of an atom with a specific global ID -which is a bond (angle, etc) partner. LAMMPS performs this operation -efficiently by creating a "map", which is either an {array} or {hash} -table, as described below. - -When the {map} keyword is not specified in your input script, LAMMPS -only creates a map for "atom_styles"_atom_style.html for molecular -systems which have permanent bonds (angles, etc). No map is created -for atomic systems, since it is normally not needed. However some -LAMMPS commands require a map, even for atomic systems, and will -generate an error if one does not exist. The {map} keyword thus -allows you to force the creation of a map. The {yes} value will -create either an {array} or {hash} style map, as explained in the next -paragraph. The {array} and {hash} values create an atom-style or -hash-style map respectively. - -For an {array}-style map, each processor stores a lookup table of -length N, where N is the largest atom ID in the system. This is a -fast, simple method for many simulations, but requires too much memory -for large simulations. For a {hash}-style map, a hash table is -created on each processor, which finds an atom ID in constant time -(independent of the global number of atom IDs). It can be slightly -slower than the {array} map, but its memory cost is proportional to -the number of atoms owned by a processor, i.e. N/P when N is the total -number of atoms in the system and P is the number of processors. - -The {first} keyword allows a "group"_group.html to be specified whose -atoms will be maintained as the first atoms in each processor's list -of owned atoms. This in only useful when the specified group is a -small fraction of all the atoms, and there are other operations LAMMPS -is performing that will be sped-up significantly by being able to loop -over the smaller set of atoms. Otherwise the reordering required by -this option will be a net slow-down. The "neigh_modify -include"_neigh_modify.html and "comm_modify group"_comm_modify.html -commands are two examples of commands that require this setting to -work efficiently. Several "fixes"_fix.html, most notably time -integration fixes like "fix nve"_fix_nve.html, also take advantage of -this setting if the group they operate on is the group specified by -this command. Note that specifying "all" as the group-ID effectively -turns off the {first} option. - -It is OK to use the {first} keyword with a group that has not yet been -defined, e.g. to use the atom_modify first command at the beginning of -your input script. LAMMPS does not use the group until a simulation -is run. - -The {sort} keyword turns on a spatial sorting or reordering of atoms -within each processor's sub-domain every {Nfreq} timesteps. If -{Nfreq} is set to 0, then sorting is turned off. Sorting can improve -cache performance and thus speed-up a LAMMPS simulation, as discussed -in a paper by "(Meloni)"_#Meloni. Its efficacy depends on the problem -size (atoms/processor), how quickly the system becomes disordered, and -various other factors. As a general rule, sorting is typically more -effective at speeding up simulations of liquids as opposed to solids. -In tests we have done, the speed-up can range from zero to 3-4x. - -Reordering is performed every {Nfreq} timesteps during a dynamics run -or iterations during a minimization. More precisely, reordering -occurs at the first reneighboring that occurs after the target -timestep. The reordering is performed locally by each processor, -using bins of the specified {binsize}. If {binsize} is set to 0.0, -then a binsize equal to half the "neighbor"_neighbor.html cutoff -distance (force cutoff plus skin distance) is used, which is a -reasonable value. After the atoms have been binned, they are -reordered so that atoms in the same bin are adjacent to each other in -the processor's 1d list of atoms. - -The goal of this procedure is for atoms to put atoms close to each -other in the processor's one-dimensional list of atoms that are also -near to each other spatially. This can improve cache performance when -pairwise interactions and neighbor lists are computed. Note that if -bins are too small, there will be few atoms/bin. Likewise if bins are -too large, there will be many atoms/bin. In both cases, the goal of -cache locality will be undermined. - -NOTE: Running a simulation with sorting on versus off should not -change the simulation results in a statistical sense. However, a -different ordering will induce round-off differences, which will lead -to diverging trajectories over time when comparing two simulations. -Various commands, particularly those which use random numbers -(e.g. "velocity create"_velocity.html, and "fix -langevin"_fix_langevin.html), may generate (statistically identical) -results which depend on the order in which atoms are processed. The -order of atoms in a "dump"_dump.html file will also typically change -if sorting is enabled. - -[Restrictions:] - -The {first} and {sort} options cannot be used together. Since sorting -is on by default, it will be turned off if the {first} keyword is -used with a group-ID that is not "all". - -[Related commands:] none - -[Default:] - -By default, {id} is yes. By default, atomic systems (no bond topology -info) do not use a map. For molecular systems (with bond topology -info), a map is used. The default map style is array if no atom ID is -larger than 1 million, otherwise the default is hash. By default, a -"first" group is not defined. By default, sorting is enabled with a -frequency of 1000 and a binsize of 0.0, which means the neighbor -cutoff will be used to set the bin size. If no neighbor cutoff is -defined, sorting will be turned off. - -:line - -:link(Meloni) -[(Meloni)] Meloni, Rosati and Colombo, J Chem Phys, 126, 121102 (2007). From a1d226f26e695c1be9c997545099b17e53252850 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 18:42:32 -0500 Subject: [PATCH 450/557] Update docs: atom_style --- doc/src/atom_style.rst | 15 +- doc/txt/atom_style.txt | 338 ----------------------------------------- 2 files changed, 5 insertions(+), 348 deletions(-) delete mode 100644 doc/txt/atom_style.txt diff --git a/doc/src/atom_style.rst b/doc/src/atom_style.rst index fac90d428b..d2ebc220d6 100644 --- a/doc/src/atom_style.rst +++ b/doc/src/atom_style.rst @@ -1,13 +1,13 @@ -.. index:: atom\_style +.. index:: atom_style -atom\_style command -=================== +atom_style command +================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS atom_style style args @@ -33,7 +33,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS atom_style atomic atom_style bond @@ -371,8 +371,3 @@ atom\_style atomic **(Grime)** Grime and Voth, to appear in J Chem Theory & Computation (2014). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/atom_style.txt b/doc/txt/atom_style.txt deleted file mode 100644 index ff96fedab9..0000000000 --- a/doc/txt/atom_style.txt +++ /dev/null @@ -1,338 +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 - -atom_style command :h3 - -[Syntax:] - -atom_style style args :pre - -style = {angle} or {atomic} or {body} or {bond} or {charge} or {dipole} or \ - {dpd} or {edpd} or {mdpd} or {tdpd} or {electron} or {ellipsoid} or \ - {full} or {line} or {meso} or {molecular} or {peri} or {smd} or \ - {sphere} or {spin} or {tri} or {template} or {hybrid} :ulb,l - args = none for any style except the following - {body} args = bstyle bstyle-args - bstyle = style of body particles - bstyle-args = additional arguments specific to the bstyle - see the "Howto body"_Howto_body.html doc page for details - {tdpd} arg = Nspecies - Nspecies = # of chemical species - {template} arg = template-ID - template-ID = ID of molecule template specified in a separate "molecule"_molecule.html command - {hybrid} args = list of one or more sub-styles, each with their args :pre - -accelerated styles (with same args) = {angle/kk} or {atomic/kk} or {bond/kk} or {charge/kk} or {full/kk} or {molecular/kk} :l -:ule - -[Examples:] - -atom_style atomic -atom_style bond -atom_style full -atom_style body nparticle 2 10 -atom_style hybrid charge bond -atom_style hybrid charge body nparticle 2 5 -atom_style spin -atom_style template myMols -atom_style tdpd 2 :pre - -[Description:] - -Define what style of atoms to use in a simulation. This determines -what attributes are associated with the atoms. This command must be -used before a simulation is setup via a "read_data"_read_data.html, -"read_restart"_read_restart.html, or "create_box"_create_box.html -command. - -NOTE: Many of the atom styles discussed here are only enabled if -LAMMPS was built with a specific package, as listed below in the -Restrictions section. - -Once a style is assigned, it cannot be changed, so use a style general -enough to encompass all attributes. E.g. with style {bond}, angular -terms cannot be used or added later to the model. It is OK to use a -style more general than needed, though it may be slightly inefficient. - -The choice of style affects what quantities are stored by each atom, -what quantities are communicated between processors to enable forces -to be computed, and what quantities are listed in the data file read -by the "read_data"_read_data.html command. - -These are the additional attributes of each style and the typical -kinds of physical systems they are used to model. All styles store -coordinates, velocities, atom IDs and types. See the -"read_data"_read_data.html, "create_atoms"_create_atoms.html, and -"set"_set.html commands for info on how to set these various -quantities. - -{angle} | bonds and angles | bead-spring polymers with stiffness | -{atomic} | only the default values | coarse-grain liquids, solids, metals | -{body} | mass, inertia moments, quaternion, angular momentum | arbitrary bodies | -{bond} | bonds | bead-spring polymers | -{charge} | charge | atomic system with charges | -{dipole} | charge and dipole moment | system with dipolar particles | -{dpd} | internal temperature and internal energies | DPD particles | -{edpd} | temperature and heat capacity | eDPD particles | -{mdpd} | density | mDPD particles | -{tdpd} | chemical concentration | tDPD particles | -{electron} | charge and spin and eradius | electronic force field | -{ellipsoid} | shape, quaternion, angular momentum | aspherical particles | -{full} | molecular + charge | bio-molecules | -{line} | end points, angular velocity | rigid bodies | -{meso} | rho, e, cv | SPH particles | -{molecular} | bonds, angles, dihedrals, impropers | uncharged molecules | -{peri} | mass, volume | mesoscopic Peridynamic models | -{smd} | volume, kernel diameter, contact radius, mass | solid and fluid SPH particles | -{sphere} | diameter, mass, angular velocity | granular models | -{spin} | magnetic moment | system with magnetic particles | -{template} | template index, template atom | small molecules with fixed topology | -{tri} | corner points, angular momentum | rigid bodies | -{wavepacket} | charge, spin, eradius, etag, cs_re, cs_im | AWPMD :tb(c=3,s=|) - -NOTE: It is possible to add some attributes, such as a molecule ID, to -atom styles that do not have them via the "fix -property/atom"_fix_property_atom.html command. This command also -allows new custom attributes consisting of extra integer or -floating-point values to be added to atoms. See the "fix -property/atom"_fix_property_atom.html doc page for examples of cases -where this is useful and details on how to initialize, access, and -output the custom values. - -All of the above styles define point particles, except the {sphere}, -{ellipsoid}, {electron}, {peri}, {wavepacket}, {line}, {tri}, and -{body} styles, which define finite-size particles. See the "Howto -spherical"_Howto_spherical.html doc page for an overview of using -finite-size particle models with LAMMPS. - -All of the point-particle styles assign mass to particles on a -per-type basis, using the "mass"_mass.html command, The finite-size -particle styles assign mass to individual particles on a per-particle -basis. - -For the {sphere} style, the particles are spheres and each stores a -per-particle diameter and mass. If the diameter > 0.0, the particle -is a finite-size sphere. If the diameter = 0.0, it is a point -particle. Note that by use of the {disc} keyword with the "fix -nve/sphere"_fix_nve_sphere.html, "fix nvt/sphere"_fix_nvt_sphere.html, -"fix nph/sphere"_fix_nph_sphere.html, "fix -npt/sphere"_fix_npt_sphere.html commands, spheres can be effectively -treated as 2d discs for a 2d simulation if desired. See also the "set -density/disc"_set.html command. - -For the {ellipsoid} style, the particles are ellipsoids and each -stores a flag which indicates whether it is a finite-size ellipsoid or -a point particle. If it is an ellipsoid, it also stores a shape -vector with the 3 diameters of the ellipsoid and a quaternion 4-vector -with its orientation. - -For the {dipole} style, a point dipole is defined for each point -particle. Note that if you wish the particles to be finite-size -spheres as in a Stockmayer potential for a dipolar fluid, so that the -particles can rotate due to dipole-dipole interactions, then you need -to use atom_style hybrid sphere dipole, which will assign both a -diameter and dipole moment to each particle. - -For the {electron} style, the particles representing electrons are 3d -Gaussians with a specified position and bandwidth or uncertainty in -position, which is represented by the eradius = electron size. - -For the {peri} style, the particles are spherical and each stores a -per-particle mass and volume. - -The {dpd} style is for dissipative particle dynamics (DPD) particles. -Note that it is part of the USER-DPD package, and is not for use with -the "pair_style dpd or dpd/stat"_pair_dpd.html commands, which can -simply use atom_style atomic. Atom_style dpd extends DPD particle -properties with internal temperature (dpdTheta), internal conductive -energy (uCond), internal mechanical energy (uMech), and internal -chemical energy (uChem). - -The {edpd} style is for energy-conserving dissipative particle -dynamics (eDPD) particles which store a temperature (edpd_temp), and -heat capacity(edpd_cv). - -The {mdpd} style is for many-body dissipative particle dynamics (mDPD) -particles which store a density (rho) for considering -density-dependent many-body interactions. - -The {tdpd} style is for transport dissipative particle dynamics (tDPD) -particles which store a set of chemical concentration. An integer -"cc_species" is required to specify the number of chemical species -involved in a tDPD system. - -The {meso} style is for smoothed particle hydrodynamics (SPH) -particles which store a density (rho), energy (e), and heat capacity -(cv). - -The {smd} style is for a general formulation of Smooth Particle -Hydrodynamics. Both fluids and solids can be modeled. Particles -store the mass and volume of an integration point, a kernel diameter -used for calculating the field variables (e.g. stress and deformation) -and a contact radius for calculating repulsive forces which prevent -individual physical bodies from penetrating each other. - -For the {spin} style, a magnetic spin is associated to each atom. -Those spins have a norm (their magnetic moment) and a direction. - -The {wavepacket} style is similar to {electron}, but the electrons may -consist of several Gaussian wave packets, summed up with coefficients -cs= (cs_re,cs_im). Each of the wave packets is treated as a separate -particle in LAMMPS, wave packets belonging to the same electron must -have identical {etag} values. - -For the {line} style, the particles are idealized line segments and -each stores a per-particle mass and length and orientation (i.e. the -end points of the line segment). - -For the {tri} style, the particles are planar triangles and each -stores a per-particle mass and size and orientation (i.e. the corner -points of the triangle). - -The {template} style allows molecular topology (bonds,angles,etc) to be -defined via a molecule template using the "molecule"_molecule.html -command. The template stores one or more molecules with a single copy -of the topology info (bonds,angles,etc) of each. Individual atoms -only store a template index and template atom to identify which -molecule and which atom-within-the-molecule they represent. Using the -{template} style instead of the {bond}, {angle}, {molecular} styles -can save memory for systems comprised of a large number of small -molecules, all of a single type (or small number of types). See the -paper by Grime and Voth, in "(Grime)"_#Grime, for examples of how this -can be advantageous for large-scale coarse-grained systems. - -NOTE: When using the {template} style with a "molecule -template"_molecule.html that contains multiple molecules, you should -insure the atom types, bond types, angle_types, etc in all the -molecules are consistent. E.g. if one molecule represents H2O and -another CO2, then you probably do not want each molecule file to -define 2 atom types and a single bond type, because they will conflict -with each other when a mixture system of H2O and CO2 molecules is -defined, e.g. by the "read_data"_read_data.html command. Rather the -H2O molecule should define atom types 1 and 2, and bond type 1. And -the CO2 molecule should define atom types 3 and 4 (or atom types 3 and -2 if a single oxygen type is desired), and bond type 2. - -For the {body} style, the particles are arbitrary bodies with internal -attributes defined by the "style" of the bodies, which is specified by -the {bstyle} argument. Body particles can represent complex entities, -such as surface meshes of discrete points, collections of -sub-particles, deformable objects, etc. - -The "Howto body"_Howto_body.html doc page describes the body styles -LAMMPS currently supports, and provides more details as to the kind of -body particles they represent. For all styles, each body particle -stores moments of inertia and a quaternion 4-vector, so that its -orientation and position can be time integrated due to forces and -torques. - -Note that there may be additional arguments required along with the -{bstyle} specification, in the atom_style body command. These -arguments are described on the "Howto body"_Howto_body.html doc page. - -:line - -Typically, simulations require only a single (non-hybrid) atom style. -If some atoms in the simulation do not have all the properties defined -by a particular style, use the simplest style that defines all the -needed properties by any atom. For example, if some atoms in a -simulation are charged, but others are not, use the {charge} style. -If some atoms have bonds, but others do not, use the {bond} style. - -The only scenario where the {hybrid} style is needed is if there is no -single style which defines all needed properties of all atoms. For -example, as mentioned above, if you want dipolar particles which will -rotate due to torque, you need to use "atom_style hybrid sphere -dipole". When a hybrid style is used, atoms store and communicate the -union of all quantities implied by the individual styles. - -When using the {hybrid} style, you cannot combine the {template} style -with another molecular style that stores bond,angle,etc info on a -per-atom basis. - -LAMMPS can be extended with new atom styles as well as new body -styles; see the "Modify"_Modify.html doc page. - -:line - -Styles with a {kk} suffix are functionally the same as the -corresponding style without the suffix. They have been optimized to -run faster, depending on your available hardware, as discussed in on -the "Speed packages"_Speed_packages.html doc page. The accelerated -styles take the same arguments and should produce the same results, -except for round-off and precision issues. - -Note that other acceleration packages in LAMMPS, specifically the GPU, -USER-INTEL, USER-OMP, and OPT packages do not use accelerated atom -styles. - -The accelerated styles are part of the KOKKOS package. They are only -enabled if LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -[Restrictions:] - -This command cannot be used after the simulation box is defined by a -"read_data"_read_data.html or "create_box"_create_box.html command. - -Many of the styles listed above are only enabled if LAMMPS was built -with a specific package, as listed below. See the "Build -package"_Build_package.html doc page for more info. - -The {angle}, {bond}, {full}, {molecular}, and {template} styles are -part of the MOLECULE package. - -The {line} and {tri} styles are part of the ASPHERE package. - -The {body} style is part of the BODY package. - -The {dipole} style is part of the DIPOLE package. - -The {peri} style is part of the PERI package for Peridynamics. - -The {electron} style is part of the USER-EFF package for "electronic -force fields"_pair_eff.html. - -The {dpd} style is part of the USER-DPD package for dissipative -particle dynamics (DPD). - -The {edpd}, {mdpd}, and {tdpd} styles are part of the USER-MESO package -for energy-conserving dissipative particle dynamics (eDPD), many-body -dissipative particle dynamics (mDPD), and transport dissipative particle -dynamics (tDPD), respectively. - -The {meso} style is part of the USER-SPH package for smoothed particle -hydrodynamics (SPH). See "this PDF -guide"_USER/sph/SPH_LAMMPS_userguide.pdf to using SPH in LAMMPS. - -The {spin} style is part of the SPIN package. - -The {wavepacket} style is part of the USER-AWPMD package for the -"antisymmetrized wave packet MD method"_pair_awpmd.html. - -[Related commands:] - -"read_data"_read_data.html, "pair_style"_pair_style.html - -[Default:] - -atom_style atomic - -:line - -:link(Grime) -[(Grime)] Grime and Voth, to appear in J Chem Theory & Computation -(2014). From 98bd975e9055337ff0bdff29983d1d2db1394833 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 18:53:01 -0500 Subject: [PATCH 451/557] Update docs: bond_class2 --- doc/src/Eqs/bond_class2.jpg | Bin 5142 -> 0 bytes doc/src/Eqs/bond_class2.tex | 9 ---- doc/src/bond_class2.rst | 39 ++++++++--------- doc/txt/bond_class2.txt | 81 ------------------------------------ 4 files changed, 18 insertions(+), 111 deletions(-) delete mode 100644 doc/src/Eqs/bond_class2.jpg delete mode 100644 doc/src/Eqs/bond_class2.tex delete mode 100644 doc/txt/bond_class2.txt diff --git a/doc/src/Eqs/bond_class2.jpg b/doc/src/Eqs/bond_class2.jpg deleted file mode 100644 index 493048100ed395ae9e2186151592ce0ff0f51288..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5142 zcmeI0X*kq<+sFTtJt4#hV;w15A^Tpoi6~{?VsxRgk7Xv$RPL5<Bjs#dUB8EYQt!`jvufRyjM< zrT22F00K8SQ!$k#uBQ;B@^+XN{!CR`C^nRRjic!0f6loS9;$%uvWN*wOER>|O?&gm z9Z5)|0=0ZL>KPEhP17nXWuj=WYf(ELQ{kzFs;|SY`#XQX>Et?f289j?H@1S-<6Qt6_;`SYu z(BVQ2A?~bC+L>^j{WbDyHNGe4tVvS6(x8UHQRAmKKxk+fQ05lb*lt|0ArG&x#S6J_a2W7g*9^IJFknY=`a@a7Ew$S^& zrh|{xO$>5*l*EQ#*to4%siaEEMBv!dVMaW>j>2>!V`SB1iH6CXsd6~C&L7LCPNydocRP2FzZiWi(bKV9AOcMq@ zO{*7+8*<{f(a+%P>a$0)UHR@PuATq3jok`Brt z{JdktW5;(~tdSH@#>tY+ek1=h3$EXz%Z8j`o;wi0Z+8k2{Z3mf_!R_n@^2D8-02D2 zG?KxTAnp1W1SsH_qR*&+60WK8uwFtj*i~Z9bl^)v&gb(fHsvONedgjF@<^;?3Wc$z z_Kf%n%8XHjILBV;wX6jkrz@d(_xv+Rc%q^g@dDRcS=YEG?9@>0*RGbiOafXCCp`2! z<*SLTK?Y%Y^;ZtRrMC{>+X=6`lC8>}vMHChShhp=wKV3j#@1eN2VOhdF){}xh8uvU?$s|y-A$`j)o0>oLNLel3!E^|ib&}XJ27U?B#evKX|)6rL-4zuqWChO7jO(&kdoLxJ*5 zZ!_^#hyj^}RbwQL0F&wg8TFNHGezzbQM~F`Ix=)Wfr`rmqXC# zJ`42TRb4dFvGq8-*(RW3g`e+9@5873VG7XZC))*H=mfE1n3fXvGbIXeKj&2IEaTfT z|0?3F_z5WnAKmQGLiBODPh4#>kZt}oOYSA*`#iFSoW2{zg*OWa-mY{A0xePj&Eb6- z+Z}vN9SUTmYLzYN?4QV?%z+29Bx@Xk>vXNqSzYY1)!;%?w+Phk;?MH4pl^@w*=<}7 z5{^y@Q|qz*s6Ery52L}mslwaJB6gIYLfU;8Cq4{F`?2P&V!^xx>IaV{yQS{O>I>Q# zf`Ua1Zh~)k?^7B9e?`3qg&2Rxz3+62PDHa8HLH|SsEM>lftE+T0a#_xzFqAAHv2uU zG2eDO0&((nLX+Y9$n2DBZ9lOIoUSQspPRPGc%)e{uSD9fFt762Z^1`oEPP(~yM&Qr zd=s8OE+dWZ0nZR zJvlg)(lR$jnuB_1wBMeqjF2#p4zIt?dP zjP8BMbdghjlm%kd6!EDY%>^D*O>kxC^P^yA%qZLfhiP7l2AYz3FNe2aH$9PR4r76Y zXT+W_RlC2ri0^HK9)`H#@+T9~8+Dw^gIA6DD5i))62-JD{!CnC+PDU(Z>zAK_M6bx zK{%)RCD3Y_gYCB`0uy%t3YxMZsk6~wM&R<*ij%L^pI(zt?A}p+{daEefzig#B+cvy z&iaTqQz_eJH95qh3-UG|UN>+zixo9aD8i#GzHZ{S!WGkPNj2}!)~B@gy)RIKfUi^_ z$u`rrRXaocLU5jZ-?cI5$;87o`I)pl)@FEsa(BySFlr2Xj8Ck*^1)_L#IVw2=7a1| z)~L^%Bfl3L64JgP+~o74K1I{=%4P#ouixTJcrAZ?YpSBF_?7T0^+7kL;k!*kvIYge zM5o~i^pVi~ceS?P9~5*Puv&7LWvZs$Abcl;h8z(Yfgtd`GMi9I}FNgzAy zZNzYI4Z6w-q4}!omVI$LH{|#Pv2K3yI39N(^TH=C_=-fH@zdU0uDyY^j}ebgs7=PPcdk}XJHUR@eI702 z)nt^8zni}XRv(-vP=TKrXzY9_CV?jDagT4}S}(?RR<^aLc_*9p;xOw(Yrd$q>REL4 zz?CeW?4A{OUA~is2LrIjBY|ge{_LCKp<10r*YiU3`Zm5Rc)j;aP(g6XQfjY1NpqdN zqT*6%A5+J18MK6mU}xdw6EKQ>jymI2kscx%zwISpunfG_SJ~(Uzo9*oFSpRI68L@KTnIn_8o(uQ43Irm| zzdBp9eNa+h0g~fG!C;XY6g*QuWk&x zS2uR^k7v%1xA$Y!6?)&~dc-t4oM;XfkTV`qfzB5BvuW4g8eUFbKhN3a$P!SaJSEzx z+jk!%k2+hRRCm#ntE@lXuCHpRZrI4bj`!+!_Ppo$LXwYNRa7dXuH)M~+e1}NwoW@_ zv7G_Ki0|30=9Drb_Q&P9n^$k!6O_M|J19PsyT$hn6a3;7sSO3#2Af!|-Lb4Xv8$*| zFP&cD7)hCG_hJ9>Ox?Cb*H7Kfa$R<-d%Ns==B0^*s|PYF=+RYyjq!np@e4u9ZkcOt z$UsfjxS5BTnDL^QTM8i=Thk5qv3A+c@u;3e*;>&@`r3h=khe`*9i;@x%jllz01pez zB1Zlnq6Ov5&hEivUlzdQ%#z@2T=?*G|8Q&W)4Z1DlZn#WhBb1%3M&avR-+!3u(nYQtPL2fPr)L@~oxtwb!3_JuEH2O02Kv zX@@hwORErPj#GCl|C{!*Iw=^k?)o)XV_dwAx0mw80YPq{@fvy2q;4A*uiu4rVei`- zc2-b5URv)Xq!bLsULk3oWpN7{rC6tcc60G`+654vT6vS=#v#6#EmD6id-m{b zd2+4Tz_xw5IPT~LbknzP@1{5UrT8ZHz?_LBVHo{L`DLb)c9F=>U;N#)SY8B z*+x|**fok~vyYw zK(Fmv6j#%QrKvnI5(}aq?CbC9B5*LW0y`XR`Oh<$&>v#E@AuquEipr*wzWt1`ubw( zBDBF=wK#c&6N8Zu57~yofpx!N9@0TgVGNTnR=&`sB2#I?&FvNW+_H`nFSOw)^9RqW zMbxL0ReucP;xFiR^hD!pA&^WR|PHi&ahU11$zz=JF z9bd|WFNdvW3m0v%Jo^l}JHWE`7l9!52^r3$Eh@lW+2=zh&h(knn#WHU8VfaIJGk}7 z12;H~nlYnIm~RUT1--|4@U;7D*2jB)6?$N=dcZ(Y-C5&!4t$TAkq+6(>rknxR6{pB zLbh+m)DkmSI(lu*o}1<8a-JcarApVV&AIa;{H@sNSA34`sf}A>faztwk?WUp`n0z% zvudOyUArJ9i1|yQ5`&tn3{qu!%pxeWE0{IEj*=3;*JxC2Q4UiSgi4NnH&14>QS2YE z0SQIn0-uGKLs4Xlo4R@o9gS^D&q@3dJUwmQTVI?If==JY`|VaXG}Zv-gdCUf_xSKpzebYIr& zIYQzq_0R7HC0J_Q!1qlYUO)cjCZh?G=$@c39N9j1Rz58`)vfzjqf$Zz7GxTr`QL+) z?OC~cbOZay_1Z8S$^!$w8(%FK(<&JJ6ei0pcfB_joJvN!@8sT}kL80)V{UE}YLuf^ zf0Yz$g%mXjHTcOcv#HI1IwIex?}--Mi3?8rmUc}1MqH{+{K#0!RcV;1C)bz>aR?Qbd zlQroR?imie6~oMBY8cK{1!^xfJ+7Yddhfq;ul=a;s>=nFT4sUEQr_`@weD*@+Klak zqo&ERNdca^y7$7E6IM}<>^M@Q(T-*=H+S`s07UBfhzxR38)(G#qyPuz0=c#n+tdK) zXu^P9g2v6@3-FH*Qk>+``nNU{vY4%wf3=6zxi1rKCmZ;prcG4Eqk3R`GV7$7kB5&c zrcs}e6D%H{TDPb`eoWNrGDn$)R!79+MhnrTriePDJEfvo5ohDuez4yq8EVHLCUyUf z)pjQxYAE0vh8wJMR_5lmhfK)v|C1S{9>63;{(#%mIeO{(C29J?4o4tnZ-LklezKG+ z_3u2UdOGSnDRaASityq6i*t zn-mX}^}n+rcnqU(SYHiSw*M9-hhQ0a# diff --git a/doc/src/Eqs/bond_class2.tex b/doc/src/Eqs/bond_class2.tex deleted file mode 100644 index 0735b61025..0000000000 --- a/doc/src/Eqs/bond_class2.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K_2 (r - r_0)^2 + K_3 (r - r_0)^3 + K_4 (r - r_0)^4 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/bond_class2.rst b/doc/src/bond_class2.rst index 9a7987fa39..e3098ef6dc 100644 --- a/doc/src/bond_class2.rst +++ b/doc/src/bond_class2.rst @@ -1,19 +1,19 @@ -.. index:: bond\_style class2 +.. index:: bond_style class2 -bond\_style class2 command -========================== +bond_style class2 command +========================= -bond\_style class2/omp command -============================== - -bond\_style class2/kk command +bond_style class2/omp command ============================= +bond_style class2/kk command +============================ + Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style class2 @@ -21,7 +21,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style class2 bond_coeff 1 1.0 100.0 80.0 80.0 @@ -31,10 +31,12 @@ Description The *class2* bond style uses the potential -.. image:: Eqs/bond_class2.jpg - :align: center +.. math:: -where r0 is the equilibrium bond distance. + E = K_2 (r - r_0)^2 + K_3 (r - r_0)^3 + K_4 (r - r_0)^4 + + +where :math:`r_0` is the equilibrium bond distance. See :ref:`(Sun) ` for a description of the COMPASS class2 force field. @@ -43,10 +45,10 @@ The following coefficients must be defined for each bond type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* R0 (distance) -* K2 (energy/distance\^2) -* K3 (energy/distance\^3) -* K4 (energy/distance\^4) +* :math:`r_0` (distance) +* :math:`K_2` (energy/distance\^2) +* :math:`K_3` (energy/distance\^3) +* :math:`K_4` (energy/distance\^4) ---------- @@ -98,8 +100,3 @@ Related commands **(Sun)** Sun, J Phys Chem B 102, 7338-7364 (1998). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_class2.txt b/doc/txt/bond_class2.txt deleted file mode 100644 index 4390e3613c..0000000000 --- a/doc/txt/bond_class2.txt +++ /dev/null @@ -1,81 +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 - -bond_style class2 command :h3 -bond_style class2/omp command :h3 -bond_style class2/kk command :h3 - -[Syntax:] - -bond_style class2 :pre - -[Examples:] - -bond_style class2 -bond_coeff 1 1.0 100.0 80.0 80.0 :pre - -[Description:] - -The {class2} bond style uses the potential - -:c,image(Eqs/bond_class2.jpg) - -where r0 is the equilibrium bond distance. - -See "(Sun)"_#bond-Sun for a description of the COMPASS class2 force field. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -R0 (distance) -K2 (energy/distance^2) -K3 (energy/distance^3) -K4 (energy/distance^4) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the CLASS2 -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none - -:line - -:link(bond-Sun) -[(Sun)] Sun, J Phys Chem B 102, 7338-7364 (1998). From 5f89fde6bce07f13dc7c3561d49eee2e40b5babe Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 18:59:49 -0500 Subject: [PATCH 452/557] Update docs: bond_fene --- doc/src/Eqs/bond_fene.jpg | Bin 8322 -> 0 bytes doc/src/Eqs/bond_fene.tex | 11 ----- doc/src/bond_fene.rst | 45 +++++++++---------- doc/txt/bond_fene.txt | 88 -------------------------------------- 4 files changed, 21 insertions(+), 123 deletions(-) delete mode 100644 doc/src/Eqs/bond_fene.jpg delete mode 100644 doc/src/Eqs/bond_fene.tex delete mode 100644 doc/txt/bond_fene.txt diff --git a/doc/src/Eqs/bond_fene.jpg b/doc/src/Eqs/bond_fene.jpg deleted file mode 100644 index e8b909c08f715e75e1944205135882f64f17985d..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 8322 zcmc(EcTf||*KUyhA|RrGgdzk)C4kfbp@>Lt7K#K!AV>>6kkCO z&_eG;>AiQPUB5f?`{unf@BQoEx%b(bot@d8Ju_#X-E*FEuE(!u0k_nZ)sz7wBqRXU zKLc<*1yBT#lai5a@37uwU|`{5 zVP$9Mj50IL78A`iIge*XU%N;I;2?AL%CwG;Io z?+ka3?D7lg{%?ht*w(S$dJ=841*mX9Dn=c98=7fVaEZe1+Rh z(AGsEQ}rpz`@GJSw^2k&OH69*X1|64G`ivN`3u|kd!rR&&QD-A&8otq_mLVVqYVyY z{!f=}#{K7NXG(zEgJetbdwl#@vE%SgTjiNsEB6xa?w;0Wbec8;ivty?ZA_iK!=dSE z#)E26pp;fZwOO$8k`#!AJD(!Pu3zY;3nLf^4l9XrrX`Al_59NRG^e>lYi z4dk3>YyEMsp&#pRQiM{mJ0h@m!FI8HR1{TjI|`@AXdBztKu{S$R$`oKUq#OA{tI{a@$2dGNz@bNHO`6lHTJH7 zx(O_KuiPxP9L+&QqYiImX%t~Ha7076`i*7CTu<~T2R5o5GNGAjEnaj5^*OcbM1@O` zOQr*%@kOmq(#SnQ&UGUOLrViG4T0o*j9bh26ez1w%x#L#a@1dz;>J@BUJqi-u%s{F z8XK9R)V^KU5Kh9fcqT2wdVIm=ePCm;nYBnX6P}_z(}@+PA08Z>rP~9yUv@C(H)J%< z9hDwpAuzS}LJ-DVb&A0o-OUns_Uik|t69U{3)uH1^QKipzESYvr^^YASofJyz=xip za*|f(dSl2;E_F9oeo6lDt!0rt+ec-3kF79*X^~kL`7EKWX3pt&+8O@3mcxKI>>RV~ z-HqN~B>ldK7)y@+&gaT=W~z)@JC7mw!icV0-fo!_wNU#L$A?oBWiU(1d1+4N$nDSK z4F7=dgM^3Xu9d1C3yxkHvw(B;%a2sk?BAdNgVx2ne8YhOziTiTVz$e{!8z|M?(9hx zd1!vxD%DP-FE=+ps{mPzS2&#j@tSkAMs+gYDc1lfV{*bU*slNC-soq}(NbeC`bR5% zxE<6b>r82w%)(E!_}^6&@8rYk1mvF(x=uN7!P5oC>Y_)@=qORhW)}%y#>=LufHAze zTdX(}gfDtHN=>83WI91M-XC6E9~+0?J}$49Z;0{u7CVG6&)u^E`pOu?2s#RrwzM*w z=2Qelmu5v-#jV@oO_<9;35Ywta%T67KGUz3d&rR0UnSk*i=2-kRZ{uqp?#I(a*t+4 zATD>cBX4~?b$;C^9@PDekIrPEeBb3>@VfRjpuSn~{6unVUD3qHsN;%N$+G1_MR9fD zvj6WtPZ@j-2$8F(eS6`sa`v_@3%mgp9&OOMh(ZLENxMioS|-og4yS&@S$Vzb|2ffG zat-)GnSKAnJ-x6uYVgX>B&#u|#*&q#>;1(SVqMxjM(SOM6*MOWj_}=zO)V%S#rG;Y zZtv9r1rkd4c*)k?Qwt*sc9E2(8+^n;ssZ8J_7M2>b;9n=W7MiSVyHQxGO-e<8nYC< zfKk(4+%{r_ecxOinAy?|z0Jhi_=aWI_pZf-zvS-kf6f*qGB;JvZ~TtEtM@5 zKgc?`J2+Pdb*%aLA=}AVB_|_vG&@#&ZP{M@YlfL!6!4Bpi8d!4BN_qZIrNdf8!BR$%TX!ULz9fszr_w&zFNf$ zXC>PkC7u}}8+Lg5#tM#{$N*^f8k7 z>>dl}peMKAXr!sKHRSv1kYr+A4wePiweK$;kkY0#2K&Gx^Ju+f!_JHz?ET=e0Y6l1U_=HUBEsG%j+^{|8BOmhK%oik6^+ogv~ACBn-_C(SVlGe)VrPaEPLDG zP_sv6D?8OQsGEYvH}tbDdim865)hpZFJUgOyeZdde^ual0{Vx5TLG>~Mb6%A@6MjP z9Wh*?oV=6ACz)$pYLnuL6y&~RbIrsUHm1+^9QIAdH~z=Gkl7bAW*7bK&Re0T^EWjS zaJ2O-^!WY_DjtT4)jbdtscD^7ol`(7)pWB+pf1_cK)3`WA=L}0V(dWyT=(>5L<`)* zQu%x-mN0KKT6TMV@m2EX(DtcA9&{kBZ$j(jOYq*WKaEAGT&vA>{`d79i(+(2a7{aiJqZNbo z>JOA_TEG$1#3a?OvDmg@#zf@BK(+NkuMjA#(z7vX$s7d|AbRw=-o?}56`T9*Ge1>jRk7Yn<$bgib_^_#Tc8Q%ZY-Z_Qd zE3DE#7u8&cx;-vCsV>fa^T{V7spg#jrEc%PvA0lQGvcwn^(fA)Tq`PVtZ=Alzk}O5 zFXvb19n4vZZm!&_+*tz_re?1aoXBh0j~c)m@qq21_9J*rHc!mU?q9^g$uRkO zo#GN^KVaRJf%Chc%jKVUoDeVwPr5&i;J(Fj$L@A}c^aqGh=*6Qhg8rDLKpmV^OI1? z7JXk{8=E6>W1hpj4>h|U!6GB~q_`iw1Ddn~JIJb-RCn1(mZ0pIDNd5S{d>gs;ltnZ zdlpzs`seqK9=Hxv7y`RCZp#v_M9Ku&&jo_~Tvx9H9(y30!2oCA&hyG%k< z(9vB2EKmIM>nF=Z@Kwd|sLzMN$s7&emoJAft#Z|HA^4-a-7cMzdNJRZqgY_Xyd~eI z=3L9!!1U_r2{DdDg7ub=0ZF*)pc1v$Vulq`!`z^@NzKIDcttYyU{eA}K4XZEt-qpc zx5eIV>KT&8%%~U3ZWTRZ;^Kr`3S4y!>xp81=8CV3G(^tj>f6!dUF9M;Xa2Gc^8%^I zr-)l1_cL0Q~tva925xqJRue;Cov}K@K_R*>>p_>d7u^pgpu^b+S;;j&=LlDY|Je)TS zf>wmI{UkQzPelc;0d@r!hB0a~IkkKgy>15GsqtG#Ph@q}BA@R(1l4`gE@c%IDZ?t> zU6<+gkN|+p{GFfIJTbO8gV;g7`EgP!js?bOw~!}T-YYm1qQu&=Ib;__Cz30id{&^5 z=_R^<@Jc3@$0oJY_0dnI!n>=tBpL#%2(3RtYClu)aXbkUVzgL&doKuQ4Rwz$8+VWY zXwwaA4rh!IFM?XXp@&6KIpA8tEP9eeT{h>AYEH19_*0Rk?ek$1`en)m;t z%K$06&sO;HYe?|TMZD!wnlc%gNO4z1q1wKvkuLIOPc%f=GS)m@ z5)GNKR|##KD-)??&)+?(kD85`Wc)T#xRZJ4Of`P2JQ^_5x0bL?&jpMglHqF^8}#(k zG~KW3p@7^lUN3H+fZvSaXw3cG^GCc0qAsNyGA&2nvgdOR>4NnwUq6aVAO@Iw8Q#NJ z$}V9|r~N6u7h419$+d^yZ3*REVVC4j3Ln;bxM^iTZS936N;@p}Pnv?C!W-TJ44_4qW-1)p*?#!Q}v|C9?-V zk;1HcZZ4Ehb7Xy$PivIAm@2*o%=Xk=R#d~c+B`ooo7!!Lx=(?CGW3B@sirBFciCFE z5dI)Md7`t^@rC2;v7FX9^J0a*HesnvX{l*@U%#wKs)@^*jpLP_iKDSi+WS)}FIbI8 znIhPmNXOQL`~a-_2w}(Hr8y}7(YGd~?1ve>2Ecq#l7^SOt9^Tuzcx$`B~x1wCq)A} zcmZD9nPj7zw-l30&Un2rL^zDIK1~fkG8}^q(w z6x?Ucg_;6dk0VFWsm!2=SiIgZLbgNUrxu!na&grC3K(2*D)GzHJ;m5 z`gjyOGuoDLc650LQ;FZKkdfDUX9Jq8-#S$I#LPY|4MA3~*ni+Y2p&G2&Kn)Z8bR1F zWI?bW##m0BUkMMYI8m1de;0LMFh-gNs&6$qD43*L`SIWU#8@A>iOcSj;}QEX>|ZHk z-3FJ*bs8yJG)u=0pr6M!Ste?UmX0FR=B1I6F`S6-}pxaf{isqZBo-VvZUI}$$BD$FNFl=e+$RCAP&l{H@@sag8>pHcL1 zc(|DV)2ZlO`>~SsbbO|vvEUU1c~LT7=KQ!P?i5*2qI8kV681{8WX6al_)iwTa3*hn zDZOzBc6RJ?y?jJ>HP%AlJd3ISovCm0R%rPe5I31f^XVYN5pt@0sCRDiwyw@&TB>^4 z;T-KCTNHLSK4*29m?KX>_+j6O{mgE$g$Xt0izf9DRhOPLc`{9yOEds9Xp&UvCWuh< zrV7saw3Af8Dadd%)~VBpIcXl+BK}iaD2=6(x0l|!DCQdQNG>xQ^m}JyWL)P`uber4 zieWfkw$4a2ClI2#cT+HaQOrT{O^fluP!5b*w&ix=|4QBD&tsCtP1to-O0=KL+d>nHCTKmX5<7kUBvWO-IS?n!@Rg0I#~+AQqDB%buCa-v(hMaCI^O9NKtRLssPm*@Z&hqR*)r;9PgmUl@-H^ zBHL`*z4AKA+9HxzHxA<%t$-k->!7!PW}!D?3V z)h5Hh0U}JHnGd(;A$zh0jzP8d3eVUAbqtKN9c81-iTq!2KdA0o&a;4)N!tFDGI)*z zqgU|!ivCCqV-hkug+0Ae;|~BmF{C>k>dF-9A2uusu=w`4Cal=EVZ>4o6mhZyx1n{{%N{sRIf9Tq3ED& ztbmCE8(bdGoz!(8?myZsh8ZWR1a^!@{FcQ>*WSyVwM^}89`R0Jl!i>r0Sa~T2s&fieOda)4l+& z17eOSA!rCX^qY?Q`^{rLfx(U?LH#2B6aq?_W$sgBLkZGovaa`6PWoIKz)eysp~mVF z_6ZYT3SN?Jtw`%Yrg5HfEYS4FLLHhv*PSf=%tPhlUat-DEh60A=be7_%?05q@Qcl* zW`3*q*d{({txvpIfz4{#>7C{c@>BfU%=_12XIL`O-d9bysihAe%`^b;FU^3KD1hgtW3K>T~5O? zyyl_T0Oi>2c*9wp0$R!=NA^?eF{b6rdD7GRcgC%lA&N$CvD1WMUzpQLwc0{rmC)T_ zo6B2l^&AHyHsQ-)@>xpzVbWU4m3J?hUbY9GW!^beNk@H;S}E=ql${>6>FSq5c3uP4 zN543mBXuIW-Uj9hX{!`=ZHhU%I@RMrl82i^P+4}wmfIGU=14@+PZ0Bg2J)bwxL`58zw9?{eO^?OBpcG|}VbkS6L z|GpXkX$WE)mG`x5j;s1m^YH!=7p&l{v$)mi86OB893sFmtMj@BbxwPJ%-$99k04gH zVeC~g34w&dJ<`#fvZzQKZwJSq-ol?+W2w=z4}!`F;@^|h`yFJ)Z#Tgo-V@^iMnJe2@ZQW2ld{-c$;*KT0L_xUlndW&dRSRjIXJW zjQqQ*DBSR57Ff5ZHpkiUh9-C#Zpr32-?0LEK3VailnHn2oyDr-@Up^ZI-y@Wtn8S} zJszK_3%SpvR|zfCy6-GGE!%*;(oMV36oti#^L$!*3|}vUamwL};fD)w3(4Dy& zlaJj0!Q-F#gV%t+Y-Jwg=D0|E*hywcS|pHyT@*#1#z4fR@*BgQxMpa)6}Y@sx1=~S zgLpy39wVFBlV6RJk(G8aby(9Shn09NoTVSaXL-c4ZQ#c6tj}A;Z*|aTut~Vfx-YLhW zQF?Z=ThG#z$3>7?cslVXK97jDg@I@{@fMA}w4^Soq;58Ia*4R0;gq3JSjyJpO54Qm zk{|hLUGJ=YXRuS+k5uXfudmQf%22OshlKRZSIm@tPyXw;$M|mr;CBJK^+6SPGSc#G zxxbW^m+XAy+RiH_{=$869a7(37S2kPJohL2lM{E2aasy;s(meOF+Ee^Zhqr`T#vHAU0_Z%K0AVmmWD zXn)pU$!rvXpKMyqO)>}>q{`ul`$XGnw8NKm5}(3XN8KkDLG+dY%#GoXz92X>C%U#6ZKrh_H$NTcjb5FCbGsK~9?%4*G&-qbqRwnP_E-&g&H8O@g9T}23mn)9Q-z4jBiuEw4 z?sjVAA~cMuystu_8R^m`fmH>*^n7W53q2dG5%}tQz6LiIb5W;(Q%R%h^T$fW0Bb@4vY!+a9F=LNDZj8*1+#IIb_y~Bz96Q*K0bqt)@h%cg|TWqtPCsco@GR24R zRj%JNp#MnMk*~o-J(B)c9C4srQ7E%>y60`Fxkx9s_kmcUFWprUlCGtecVmSt3PidrPGpuA4 z)ocXrCC+UZv};A;4e~56BgMquoFW2a>%me>B}fU5z)R&>x2YHZ)eL^=a=I?%{Wi@~ zy9!k>5l#>jp`AR=*t-V&`WO~GblRZTSuzreo=TCxpEKEOn7;<930TQskO2xvOv_ds zUqi_k?jHA<#NL@f)*|J3F^aEU#F*BJe3K(bvAdeFPnT<4&L($BoGANup$=7=&vk+r zweJ~q^Ee5YaQt8;`Rmo6zogH-hRK{(G5d%@NXMeG+-$$H&!I`CZHhuo8PCelyz>C RE9+L?f8X-|cyT@PKLAy;0R#X5 diff --git a/doc/src/Eqs/bond_fene.tex b/doc/src/Eqs/bond_fene.tex deleted file mode 100644 index ec4dd8efa2..0000000000 --- a/doc/src/Eqs/bond_fene.tex +++ /dev/null @@ -1,11 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = -0.5 K R_0^2 \ln \left[ 1 - \left(\frac{r}{R_0}\right)^2\right] + - 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - - \left(\frac{\sigma}{r}\right)^6 \right] + \epsilon -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/bond_fene.rst b/doc/src/bond_fene.rst index cd25419544..d952321c20 100644 --- a/doc/src/bond_fene.rst +++ b/doc/src/bond_fene.rst @@ -1,22 +1,22 @@ -.. index:: bond\_style fene +.. index:: bond_style fene -bond\_style fene command -======================== +bond_style fene command +======================= -bond\_style fene/intel command -============================== +bond_style fene/intel command +============================= -bond\_style fene/kk command +bond_style fene/kk command +========================== + +bond_style fene/omp command =========================== -bond\_style fene/omp command -============================ - Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style fene @@ -24,7 +24,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style fene bond_coeff 1 30.0 1.5 1.0 1.0 @@ -34,24 +34,26 @@ Description The *fene* bond style uses the potential -.. image:: Eqs/bond_fene.jpg - :align: center +.. math:: + + E = -0.5 K R_0^2 \ln \left[ 1 - \left(\frac{r}{R_0}\right)^2\right] + 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - \left(\frac{\sigma}{r}\right)^6 \right] + \epsilon + to define a finite extensible nonlinear elastic (FENE) potential :ref:`(Kremer) `, used for bead-spring polymer models. The first term is attractive, the 2nd Lennard-Jones term is repulsive. The -first term extends to R0, the maximum extent of the bond. The 2nd -term is cutoff at 2\^(1/6) sigma, the minimum of the LJ potential. +first term extends to :math:`R_0`, the maximum extent of the bond. The 2nd +term is cutoff at :math:`2^\frac{1}{6} \sigma`, the minimum of the LJ potential. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/distance\^2) -* R0 (distance) -* epsilon (energy) -* sigma (distance) +* :math:`K` (energy/distance\^2) +* :math:`R_0` (distance) +* :math:`\epsilon` (energy) +* :math:`\sigma` (distance) ---------- @@ -107,8 +109,3 @@ Related commands **(Kremer)** Kremer, Grest, J Chem Phys, 92, 5057 (1990). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_fene.txt b/doc/txt/bond_fene.txt deleted file mode 100644 index 9ec4017d00..0000000000 --- a/doc/txt/bond_fene.txt +++ /dev/null @@ -1,88 +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 - -bond_style fene command :h3 -bond_style fene/intel command :h3 -bond_style fene/kk command :h3 -bond_style fene/omp command :h3 - -[Syntax:] - -bond_style fene :pre - -[Examples:] - -bond_style fene -bond_coeff 1 30.0 1.5 1.0 1.0 :pre - -[Description:] - -The {fene} bond style uses the potential - -:c,image(Eqs/bond_fene.jpg) - -to define a finite extensible nonlinear elastic (FENE) potential -"(Kremer)"_#fene-Kremer, used for bead-spring polymer models. The first -term is attractive, the 2nd Lennard-Jones term is repulsive. The -first term extends to R0, the maximum extent of the bond. The 2nd -term is cutoff at 2^(1/6) sigma, the minimum of the LJ potential. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^2) -R0 (distance) -epsilon (energy) -sigma (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -You typically should specify "special_bonds fene"_special_bonds.html -or "special_bonds lj/coul 0 1 1"_special_bonds.html to use this bond -style. LAMMPS will issue a warning it that's not the case. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none - -:line - -:link(fene-Kremer) -[(Kremer)] Kremer, Grest, J Chem Phys, 92, 5057 (1990). From a3b3b761efe7c0586c529a5925d0c106a0edeb3e Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:07:16 -0500 Subject: [PATCH 453/557] Update docs: bond_fene_expand --- doc/src/Eqs/bond_fene_expand.jpg | Bin 11506 -> 0 bytes doc/src/Eqs/bond_fene_expand.tex | 13 ----- doc/src/bond_fene_expand.rst | 40 ++++++-------- doc/txt/bond_fene_expand.txt | 91 ------------------------------- 4 files changed, 18 insertions(+), 126 deletions(-) delete mode 100644 doc/src/Eqs/bond_fene_expand.jpg delete mode 100644 doc/src/Eqs/bond_fene_expand.tex delete mode 100644 doc/txt/bond_fene_expand.txt diff --git a/doc/src/Eqs/bond_fene_expand.jpg b/doc/src/Eqs/bond_fene_expand.jpg deleted file mode 100644 index 1d04acec326963cf9dd8b1fed6dbce12efa487d8..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 11506 zcmdUVWmH^Ew`Su60)!A;g9e8HjY9|yAq004f;BYmr188!L!g09fY8ASjWz^p+}+*X z9fE6Mc)ywZ-S6I+wdSr_^JC^Y>zwoB)T%mFTWarT*ZtJ}65xrNlByB_0|Nt~@^As} zX94m694u^XY%H9I2M!JnF5Y8&ya$jF5EKCgihp&cD z02o-<04!`Q{KtgYc#i-Ntue8%ad1iTo<7GX6O?<#tVQ`!&%)I+VT_zYNJRAYN3Y#WhI=JW{rf?Y9jaKgGFT3A zRIbN~bjjqHVDg|V+YH!PA`L(h3xz_f`8EB#K25W@e?K4XGTumeBCq+bx zI=dG*2zC;ACVV#9t_9ca*5nDzXp`U&D=$xLm!_DiJ7uOim!Kt00)g5rW9SHiR zW!Xg8>8HPSOHnEuA?@BT6&&T%h2l`a4Rgrq+ z@;+_4Q)S_3?w3*UxrzaC5r$vP{AjO1!#2D4&Oc4g9$P<6O zt8cgM4WAf20tOc!ypZQSe!+r$tx;EdP;-||>>A6+AkXdBQ7&c$110fj163A=Hl%Yb zn$EBp1W%;TX&Fq~?Y#UbvDq?sXM-UVS>W3BF<_DIvZ|lv7KN6qMW2H~iyZ9qQ zFF-4>l^vgc6J|+E>vg*2oIZDFb(y{9OX|wob*qL#f3vrI ziQRl>g}etm=Ebn3lgJgH&@gJF9`v=%PA~}&p}s%@;oZA3qH4c4gs+sEi)$o5N&Lee zx~aOUw${MrotSi!L?I+`MiW@Nx0=AhG>CrjOQa(odpTc1dm zm!9(;Z%*}K;f26b;7Yd`D zXr|$&t6Zw4qw>P|OWsMiu)X+Mh0y$)5^wG1H>TdS#s?><@8nf@0q%`fr+kQgt=k3n z_dm>T`u`z@zt`~};8V};37N*SsnTnI+gTf*d@u|te;ahf@hXLc$zZ&6SpM*$ZfyOn+k+ZOkUy>g{Ron}=D&yS&tiTcEOBM8`1eGP^<4? zgLJC|TskLDmL}Wclu~l=nGhlC*5%_90xj3h>|r(6h; z=&RfV^p;!K0J((<7p5+Qc1a_mvnX;W#zQ);ERK5snj)axv*z8%+FgrBb?m~!GR2;v0P4p9>q5w?l}du-fP7`2s!`blq3e%=^jC*q4aKDM54VqJ z@7!wc0eQM8!H1pJ^?k$9xCN9%jFjH!#&`oPGA`2AgC~;l3^L=0IUP8H7H5w zb+H?*XU^Ua4Q-_L?QPUEIpStx5cx85vhYoY)Yu!#B1q=zY+H{1UDLwvz1o4BTAAnr|)Ds z_wbp)Bd2Hg07ntj+JOnFRcnG=cctuC`EjXvz{vcIylGWs93JPSy)a8Fri)sxhAIMyx7Bt~aCUwPU) z`%dax1E1D1Gb4{6FN!(@5&F|fgolYgqA0$+OD3bWXJ^H$BcUkCI40eoE*434H6ckI z^lq*#+?B{f)vgJe?5;Y=>tNYu`f1lFLzf}6lpIWfzb#M<*z~BLd4<_b>gwRFG2W%*e=FR9N~cLK9@k>zhS%IwLZ3U2<}5yG&Tj zu7j?4jVNqqvaaej8iBPJh`+Zw1;xbG=>_Y66`%q1ol(he!IC#zT#II++>4TgGfmh5 zyrA7Z4mHQbzL^-2(iuLqIyWluxtPB-y$1}A*GcVzE2;#fM>#O0m3iwbD7+I-)l`qx z84~%eZuH*0(3+?L#*DR@)Raaxi~<{PR(Cd|WH?@3X;~fG=n)J0WkxQ#6=eIHJ&H{4 zCwk+W5Fu}B+``au{&Zv!FXYi^wF8*D)2Gb8Q5PNg`L8PwLe+Gtfc?O-vPNM4k%oL) zJ-FyIVSP}1u5MDhFfys6CP02Z;t>(wq(l4gh#Es)3) zeN~nnt8lr&4}!tnrMMUS=bj1G?@O->Ya|1>t;-FJGA+m}xoW1FN#D@PMMOI|9n#^! zpn#A^*mf#M%r{0+7NQO?IE{Eihjy=l5SO((&DN@A@)Dt(ROc(=RQuYfwK~Q659fWE zbe4?##p$q$giX_Rn3;6&a`K;UPyqCZX7ROhQmq-@OqO%X zuQ#irLmvIf?K$+Qvr2EZ2RUv`x>k%$>Wp=A_bm@KuqRai#0`QhGW(HFliK+I2#ghF z98mAP+WxlSnc5mTIm^jbVrJj&KNC5{W!O=Qzo^4)I7ulMvhPlY4ELmwIHG)}pf#=7 zWmHm-J>NtsuPmav7@pg5cn?quo>u#7_C{)XSkn4LizWx|WxD;-?`K+KiruJE_eVc% zVeuF{Fv73-h#;|9U)`xWuSB9ha?a`x^cy3k@)OKQcx{)EoVyYRro6{^Pi?rIk7+gy zbj^$PM2)gN{6g!OG2$*$!UUsiZm+yE>bYMs^UR7gl|j&sKvkIQYd^bEtxlC08^i7V z&xRwL^b%&VrkhVaa8HN4d!7Z(;86w6o;eR2lU(V>VENd(EdQkJ`IL-SKNYoKH85Q@J-|GVK_%+E{TE#T{H#z&%#Xr;=yp+KDBcTRrd-HXb1j&iF8Ng5h$zH#GY11-UN$_ z6X|ru>I`x>6`fRgVxXPp>MfDJJb>rg1J3(dC_J2|{4;v4IQOeU7*y~aYN1dcT2HX=+{wqb27{D-27f@^W{cTRkF3o?nO6a`p>#pE_)AQ@k^82;>+?N~(4F;Bp;jL#R=NKl;op z^C5T@dl7@qcQ&DmEwly2$((J6PbCp*y&|k5jJ+Pbe0P5e)R>uh0xR}XF7RnB7;gj4 zoY6j8vDaZ@F(XvUU20PR0Eh?xg%(Ut@Kb0iJ7E?KbE6FKi}bHQGx|(zMu`#IIJgT} z9NN+1y_I0vilL#?RxQo1RB`MN``(O0Yc&+tX94MsTLPGy`fDM>_U9%% z6cm+L|5Q{u;oFq+ISYEi^7a@eOF5()uMm`h_)bL)E;(d%DhGDlJY!!~0(pnZYj4g` z+(Q2v4e=T8Mw63k5Q*r?e?%;c=VaS0tj8)`sVjGOKZ9M-7-%yy-^T4l!{EvyQ6RPf z*CBv!{OxSBs?arzV#8Fe-N+`P>_v?!-|4%F(Vi>QiR$52s&$tw?0{UB!Mx%3Lljdl z?4&Wrw*RoB!{X|SzdC*WDwn)=MG3l0t&x%7F0C7n6xYCF@;BiBt&!AT$akBGA#sHn zbSQKWxKpRT2ec2~15V7xUfP6}J~va3LI3#fjigCR{=F#k&JaVEQy)jC$`!L!{=M|G zQ)ibK=cB5-&ZnM#XpL{?CIspah`>tS z9ItQ^%&EUF)iLCEIaU+#c9@W3?S?XiriSZiKH+y4FSptd{G1cM`$IX=#I9maNZn8B z#SiGa5XY4+rz7Co(BbcpiOEctD%l~;ioqLrI>>QCy05fOA^=83i8ke(dQTf&D=k(bhbHS$wn}lxM`-NB7HUCBwb`|R7v#@>%O6z`Z{??Xng#T=|;pc^fQPz zp1jl{#LEbaVQC?Jg2iNLp=;jI)(2W6u{A66ai;S%lOL+pX{kZL_p>PuFeUSCWrMjb z*tFAM=HLJF>pVZ*rKr#~wbykiBzrXtcOy`qZ&6>-p1&=J>21NC%xzxxL`XiA-8oVFg z=De;rQ|)ZZJ; zH7TXs>xl+JJC=az)N=|eqkR&o7Nf8B$aw>wqiH|GPC2claqj`o@@;KaNH7H4L@(gq zJ!x)V6_}bz&1YY-VU=&q-R$%l`D*q6^?M3L>sESgYc!k+GP|=84Cc04tD-cy zuo*gW>o7dQdHjWB4=-ZqbJzb<(OO-ocghg;-G!Mo6sG=fwMNIVL*1#Xo@LKpWQS3C zee;IJrXYP0c-Fg3DwMX6a(rkeii*D7+_U=5F86oBzH6=WH+3Z_nW0DA3zsn;^ilum z>PmqYCfmaflKnuarl2Po{)9(ZhqQ?sZ{LA*JK8Ty0JdPen|6eiLmU{5m&4W6On z6Nwn=s&NIcq2*p40dd%t(&=i}FAq7wFaH-Tn*gUW(g{mfOYeu4VaUr)fpZ zaIY$h-m63;-<=*Ne%h{gaNd-)WNm(l|2Iuz!u1c9BVwK)*UL2S_#Dz=#_|PPQIeka zffeHhV65E-(W??FYXGUZ-UG6rTO)qv!)xX1oj%n%Gr52G@+G=iHi*V~=_>fAZ=r}y z@ajZ@bE*w6qO^#yt49io|B~9uCqUYKM0u*_{5rjb5H=?vYHK1f#A@zHEsfqbo>8+0 z&$)>`rPs46M8@Q-_mUZtv^V5)M^XQ3`c=&@FjTYZl8U6EebCT|-29~FxH1i#HV3%8 z9INmaS@uoq)$VQ@n}(NSKygZ(u%@PgC2&W-e%>1&j@$EUokdA`i_yd?1hthvr&YO5 z83o+5Y7Z^tDu|~$MHZovDt~BGLNoTkEZ*X@914}W3|wT`<+fB|k8Ij=1^0~hDuxtQ zx}%R>Sly{GV#~Dy1ZSa(Nju0(h)vgv=T)Z1J3R!oXB}AxgLf4z_)Io!0?K_@UyKQp zRd>u-2EXg8%^2IysDgGmm-CQGq3~92tZ5dNVKCy;6aP?y`auDbyYP;{Wr4t+`rKcB zTw$eLJv_3E*?FPMM;b(E3TYSvP7%?RER{aC;=2_f8=ss(jQM_X4(tpzCk=!SsKE5A zVK77UrAHtLo&N`7sNL`|UfZfD;U+1H+W(y9lS-j*1*r)q^Y@+;kyl`Agfa*NDH?~O z-MV;B}yITB}MnU<>bcAmH*`?)%n(_gyp-+=+EcbZ6}gu0acB`Rz`S){{1dnd*?So zTidz)8X69T31T1Jy~(Jik|j!_oy8xz9^WEBuL11~8i{sGwjF^bBG&b%Z!<-lPi-pt zdDagh4UV{J46nRIM%xu#B$^Xf{AAE8)1DedHDFyLB(g9oRhc@|sa1aFT=ZK-T{JeO zv$?s;)db5AD=D3}QhgoEj^QXxJz-t=oXu0c2E!Y)$_mr-(9gM`jUCOxpJMHyW-oig zsNK+mgkj==VcQ~fBNV`lLhMgP!=tnH(b4pAB`cZ5uc}v`;n-3&W8V~7j8}NL zY?=Db70i0v)Us^-w0uIy0X?Mq&f9IWXL{Z0Fk;~A>!%Y57sf=>3x9sUr%3jG`E%vZ zu0R63X@@Yrh5)x^Hfnwsn>fDD_YO;;syB17{h06MY*|S(-ZIfIAG}7PrQu(v?roX7 zYaRc){-~7-S}`mjX3y+Svi__)H-r!35T%q?SHd z{`?i*Wcgvx${9!D@c7mYxM=s7&tcBqm44TMP7t|@@j%?Xek`qyi8OYcU^^aR0bO~f z(X6;{dtiie9QG3wA4Wf~3pQyc38Lq6yA><(_gy1pyMtl<;|p9|)%WiP*2m_GErTsB zBih@7mi%pYb6}_0JHM{4BLr*rD0=CUXE9@gtim2&tA+>ZhN;%=0zD=LV&#J$OYi_r zF!g$-cC%(KOqa59Br)Pf`?dqLO*bmf-A*SX7BzeSmpLcuDE*Tt!zI55lfA@EHv8N@ zQNIceZhb?sV(E*y)HB5xL;FKf%)6DOpko2YW2x8)rRI$bu?iG}brU~C=-{RC5`3Rr zN~G9Xxa8H!hLY;k2iJ?atXH+jE)Mxm^dM*?hd_fe%+j+mf-}3o?=dEUVZ*kL5Y*va z*>UQHNY<*0R`QE}$2s{XUL!}e&|}YGCu48fq_Gp>glXv*=EOYY>MCmb&z2z*AA|+MWpzJ#8b3z}n30F7=2g#{Z&U4wg5=Bx3=qzlM z`#BK^g;Jwxp*}bTyyy-KSPgIQ+szY+R2%p-Gl#r&5w^3urLsJ@>_vm>hrINH0;~5H zn`S#6-)tNYhWd2QO6P~h4oq>QytyFRgbTodYswScI-lbzcj34( zJO@t#{YkbR)kihjCfkOz!{y`r$<>S8SvEme#24#DrTG6W&}F#sIKfU_(Ps2oI*P6p z4a(Yjqi)_&4$u0DYp)Q(=bbX>Qgs3`N}<9ISz(?PEw z+9A+GHSXcYj8}MIxE=3a%>|0{Gj1aPu6kS|*fj{3EDAhXrFIEl|01;% z;d9SFD#-RsO|R`laD^w_re;l5{8TXF2TO*&k)qH0WpdTfwRSd!<^oolxbHkTu^r_o z$FKcf8%Fdq&6ee>KnUH`2_L(pG|t2-&)X1~fhe4`8*5=xYF7g5*cSv^J>9hz9i6>f_)^tbfcIqi>H(h4i zeh$9}#QH&{<**qFP^1*f)7xoQ#|&&X5I*b07YPX|H&bu|AP`r~Pa*uSsiMs&&4#3@ zzj2eh_&Q!~^zQ;X`OP7H;JKZwN4~8sNfSHC37hDph1_{&)Uc%?+FbmzU~>MVOP-6w z9iP>K72}h!tm3wc_SY*`VFg0VXAz4o`Sq$sV#hAXY=l0^&BFF#ZlO_hN71Y!*{I5l z&yPV~Gn17=S`BR1>VrVOCf4IHSYvcU%}DMCUp&&%C@?|yqGPGH_IxHRb63su4)no~ ztwm+d&veu6$>^aRQzAo_A}Sx5nU#u0XVTak`^@uz%@g1Zwg(? z{$www9nCmjOG3} z;fsNO0FdABuhbhlLdz`EH;=ktn)24Gr0&fGYy;qo&5zF2*2e6LRa#>{)CKDf2GOHV!mPE$A-KEdJNl7Gf#wc6c+NU$@MJ%r>0WR}>7 z($qSZYih9AtvE|ncshTna}*}+*sQ*-1$^zHk+=h1@2X`4uhA*>2o`d4_@ld3)x9Dm zzMweWuQGyvCq80vJ#tU!lGm)q4l(@{O@YowM8ZDJ%s}n(>{dO>G=y5IX=#8D#9=xB zQ&ol_>!74%@H{aru+y$_(=5T9+2!uSJ#5lu!1YVK-x}1;j&DeV2Z5ccFVdC*(3D#u zD9f+cp$!OZW5{|vF80Mf@+!!RA|hzL5IsoT&GPO099A&B9G(K{((Bvh`UR7F z0P#`5=~|MLKEk*XE>fvVXdYOXA8v1a1*#&4>u6t(C#qysj4BaF!F9W)e3iF+Wtkq< z8&zUdNUk<88VeQUd?p2G33~XwWAy_?J!zt=B z+VF6z_R8tcurXh6wyjll&#>PZcvUt;jDN3xo)LXO>=G%FAM{&gigIA*zmqTWh}COcd3oYPp`#f7Ly`9w`1 znU)bJX)_fA1oER1O14%nX7EMm(enCNN{5t_El%U<^?Lv+sjb1_t{etwR4ZfdyAcS$ zb-V|Nn+1;L>p!dtw5oW~XZIdZrh1dDBPkYuArP3v+1N_ZpJG{VP}TH)AeU`xMtx!+y!oHsxIaV^MtEy={Cr$OL(Z4L zHwUpM&Y1)`jJWN3*ya7KSH#yU5=E(^#{AWI1jQ4NodnrBwy{8AYhbL8@%u1a$2Jmu z4wZeM6p%wKDq%+r;@^-O0vDv07S;%3Cuz5Q1qf)WAEu1<_$sd`H8$3f@1?Y`K^ z^}B2OA!E8ttx~1B$ehleDdXi|D^@NaWUynie}P43Hpo7924frVm!CrLAO~4s+0%R_ zm)7sDF;wl(#}aPsTA6D}m!^X}JhYr=Os&3}cQv07zI&(!n(KM|)*I5Y#OYPE5Ss?&JdwD{;ZA9qmBcOIdGo0D}5rm2jF(6 zj1W4W%IU5yP35O2B>hZ#zNm_)H`=kQc)_%+cikM_!CE!X|#IzxBmc*#i+{fQ zZh-dyCMVhC#F&#&UO`gQXSk3k`FKNr?6Gb|6HOtm{qf=G23WpKNzd>mD%NCaqq<-E zk+wc3pW6&)nlCa3S#@lWl<*~7A)$X{!SwWjz!c3C9rwy)=A*4Z40@A(smKpoVqWy( z%A4kAzovJ`LR}SgS;DB2o@t@QriLa2v*gk}03=KeapZ6PKB14&+WqRkx0m+GZrLj} z{y=z_Y3r#-i3ho7S$;YWxnL;9K)3zZPYzH7G?L8o?Pw8r>*rA0L8(FDdd zo0A%3zC`j+HAl)CMxQ7g*Z$@?2|IL|Gd zY*4Sz{^6Bu&oWC?<$jJH>vcw2>sd0phER6Tqg6$A%4?Osk)cxPNm!OLTprs^t(Rtu zSG;aGb4#8u1N(X|4lLp2lRTvCM3%H`6Xl+g>>UpdEHXP`wIZgQw>nIE9(|%PsF)X~ zd|cWPF)*9qdhBkt+p)T||2h4F+_KIj_uxFgz^ny#P*smC1M$+cZ<2_#WXvxs_kF@A zdxWIJvkK3_A_V&}P53X7W56d$jL{#)(=^z7K|>xA!w>49x6;##>RA-AS|9uNGBRu= z?7H;rVs-sypHQ3VwXydXrCL6?zPw{z!s45r{0@axZ2qsc4sh_eomb2Y4igCp2Ic10 zOH`vJz1H#t_M!ee>*9qq6UV!aDNQ80j1XEHnhw!!6lljwBl>?jFYw?b{s|+E#L#NT zFyq{kJDzzIy8D2fd?933`Wea+89!2=aTrw>U3G;r`uE*Xx6IF-w{DIpjbVj8K=5r> zHET`|T6-*lzSOrDX$h5J0?~Vz-}1F3eYSXJ*vqG5T2EsfVWubSXu0k&+AS0T{zPK@ zS^`3z^w6cReiK*jCer`, used for bead-spring polymer models. The first term is attractive, the 2nd Lennard-Jones term is repulsive. The *fene/expand* bond style is similar to *fene* except that an extra -shift factor of delta (positive or negative) is added to *r* to +shift factor of :math:`\Delta` (positive or negative) is added to :math:`r` to effectively change the bead size of the bonded atoms. The first term -now extends to R0 + delta and the 2nd term is cutoff at 2\^(1/6) sigma -+ delta. +now extends to :math:`R_0 + \Delta` and the 2nd term is cutoff at :math:`2^\frac{1}{6} \sigma + \Delta`. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/distance\^2) -* R0 (distance) -* epsilon (energy) -* sigma (distance) -* delta (distance) +* :math:`K` (energy/distance\^2) +* :math:`R_0` (distance) +* :math:`\epsilon` (energy) +* :math:`\sigma` (distance) +* :math:`\Delta` (distance) ---------- @@ -106,8 +107,3 @@ Related commands **(Kremer)** Kremer, Grest, J Chem Phys, 92, 5057 (1990). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_fene_expand.txt b/doc/txt/bond_fene_expand.txt deleted file mode 100644 index 4d7d2d5438..0000000000 --- a/doc/txt/bond_fene_expand.txt +++ /dev/null @@ -1,91 +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 - -bond_style fene/expand command :h3 -bond_style fene/expand/omp command :h3 - -[Syntax:] - -bond_style fene/expand :pre - -[Examples:] - -bond_style fene/expand -bond_coeff 1 30.0 1.5 1.0 1.0 0.5 :pre - -[Description:] - -The {fene/expand} bond style uses the potential - -:c,image(Eqs/bond_fene_expand.jpg) - -to define a finite extensible nonlinear elastic (FENE) potential -"(Kremer)"_#feneexpand-Kremer, used for bead-spring polymer models. The first -term is attractive, the 2nd Lennard-Jones term is repulsive. - -The {fene/expand} bond style is similar to {fene} except that an extra -shift factor of delta (positive or negative) is added to {r} to -effectively change the bead size of the bonded atoms. The first term -now extends to R0 + delta and the 2nd term is cutoff at 2^(1/6) sigma -+ delta. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^2) -R0 (distance) -epsilon (energy) -sigma (distance) -delta (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -You typically should specify "special_bonds fene"_special_bonds.html -or "special_bonds lj/coul 0 1 1"_special_bonds.html to use this bond -style. LAMMPS will issue a warning it that's not the case. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none - -:line - -:link(feneexpand-Kremer) -[(Kremer)] Kremer, Grest, J Chem Phys, 92, 5057 (1990). From 5760de058764d4352e8bd51bafd3a77a179290e0 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:10:25 -0500 Subject: [PATCH 454/557] Update docs: bond_gromos --- doc/src/Eqs/bond_gromos.jpg | Bin 2161 -> 0 bytes doc/src/Eqs/bond_gromos.tex | 10 ----- doc/src/bond_gromos.rst | 33 ++++++++--------- doc/txt/bond_gromos.txt | 72 ------------------------------------ 4 files changed, 15 insertions(+), 100 deletions(-) delete mode 100644 doc/src/Eqs/bond_gromos.jpg delete mode 100644 doc/src/Eqs/bond_gromos.tex delete mode 100644 doc/txt/bond_gromos.txt diff --git a/doc/src/Eqs/bond_gromos.jpg b/doc/src/Eqs/bond_gromos.jpg deleted file mode 100644 index 479e6b2d3b2ed907e9191564d8b8edbd42ea3f62..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2161 zcmbW!c{tSj9tZH>_{|u@h_Oy{?51OBX6_hMp=_0&)Alo+4_lz|Wp zKm-K=Q4nDZpt|)=803!t{|-b1gu+DOVhC}Gt%ho8Km-DUB2W+pgF?5uZ*AQJP!vo? zUC&%p_Vi`A233v}k(eu{d9b`m-nRD>R^Qd{4nkZ(5xo<$>qjkZ9bNLCz55IdjSd~Q zu(Yy1a`cSd*>m;|j!te@+&w(Kys!EP1P0N9={FHu`~r`^yz+Tf@MZ1m z`nC%KfPb>K&Oc%Q<3eq@M4(U*3g31?L}*(DqM$H!Jy99+)9}kwSq)NznB2j{-0~)b zroQbbc~`$)aRn@Sau*4@N5VG}oAPO)A1TSbUM%V9^NN%!l zzjDeZQt&e=XC8g6(cu^>U#;VNqzkB~$xj|KK61&im2G9~_3v-vItc+U6wSu4k>>{0 znO@TeKlE6JwiEM{<5{l)IG)j#tf$-&bI(BJxddF&i$V5b$E;|Zi1Ng{p_w;BdSKtR z&Q=VQYxm%d-1Zc_tMZe(!X;T*0!(wB?&8`061S~g6+J6^V0tGuDeTPIYUQBrW3>(x z^#PYr8t7Z->`Wk8;W0!wGyQkKyVt?=Q`$n#%3`Syc*p!A1me$S=M*&+kEJj6ElBU} zBlx;MyT;!j>1O&5qaR5GMk>ZtIaUw%Y9{fk(Vs4;e)x7j@kpa<&?Q1xbY{rVDqSIE zs))?KuNvH5>d_EZ6B|4gekB^;7-wiKe@wxo5E_2N3+xNbkzS~Wk6Pwpd6b#uM-IO3 z582cEshILEh-n1NpQkWX@558v;aX$8G2|^>e72QtOOmS5ACo_S{Mj9^se#Ua(#d?$ zV{w;*h;T8}sFNylamkD~{Qchxojy$@G@>bGPV|V)T@grz>C(HnO*u%9)A26~<-cR4 zK%c7yR#HeugDo9qwgV>%W3UFxfThNnrx>YC?sOIOL)pbvd;g#I8ql0mLOmhyJoqJ&_CTCUwR=n>|dO87~zs_`adl zz-$Ls8s2H9Om!Kj3QW*^EQaO6UCSPFn9Xvpb*O4qO46t~r>B(>RJ0HmpjC$z$N{G< zw##p5f|$B;!N{WF;RRa7v9+A8mvmg`qt`(j@yl`A<5?3e;gT*V`gpwc!T8s)$C-vU zeI?y;Q4KD4Nr{bLmk}S0cmMDbb1!cb^Maj4xPIwadsn9Od&fmE^e3$)8U3nk2jBKN z^0S)yx3L?>g>R6oTzXv+uVcM?5jkB!-0@KPwQ(@KcE8guX1<%Z1}`Inr${>L+>t=n z&Ie$2+z}B|h2Pw_gKe!wu#~KUl@7sj zL%FQ;fpXnzUsdO{E|ZW1y+k(Cpn9?<^{pNML_GLJ!l&D0q~fEUY%8{v8yBITFs)g3 zl@c?VBkj$(>whsgb>gFx-s4*9fN5yj4!a`4rq2zM7`m+kXcP%2E?sBl^RJ)y?dKDN zt!V`dD|G!V-8moU*G&#m<3iv@VClHkMMauU;R1$IDi~W#vp>ok&%OAH>Wif;so~YsA1Hhq^V83~6!3J4 z0jvmtC>pJXBbTi_fLqlbJDy?fOQ4iIj-lWqZ!cDK00ssedZT>V)E;8+Z!hgTO#=v? z)gGG*Niz1PXV9v)yNjO~HKZw&|I+Tcn{tdt!5xh9B5jL@d+$myBrYW z;GV#vB{&`JEjDqsXi8)nNiv#ERtJm3bL{}25v)GsMUgBBySlvDBZ}4Y^wzv%Ne9-0 zz7)>`c?@k({3LAcsw2j#7dJYR>gvX`K?UnK-{?qc%Ns3;Zc4cuddCPeo)<1Yvw`>Y z*J6a)myDa^Oug95KCX3v2l|xco195Pm;Xe4hc=j1H}I6Q;r%@l)|pz~R2bWSCFWG6 zVnSY7rxS6eCsMYw_QgbmhnI=kJ#)+S5OX*E}9;)$dvnl`cr7C2oFZwp6l1DrHU% KJ?()DNB;%3DAbhz diff --git a/doc/src/Eqs/bond_gromos.tex b/doc/src/Eqs/bond_gromos.tex deleted file mode 100644 index 2cd8c39535..0000000000 --- a/doc/src/Eqs/bond_gromos.tex +++ /dev/null @@ -1,10 +0,0 @@ -\documentclass[12pt]{article} -\pagestyle{empty} - -\begin{document} - -$$ - E = K (r^2 - r_0^2)^2 -$$ - -\end{document} diff --git a/doc/src/bond_gromos.rst b/doc/src/bond_gromos.rst index 894fe7b87b..5d0a4ab1c6 100644 --- a/doc/src/bond_gromos.rst +++ b/doc/src/bond_gromos.rst @@ -1,16 +1,16 @@ -.. index:: bond\_style gromos +.. index:: bond_style gromos -bond\_style gromos command -========================== +bond_style gromos command +========================= -bond\_style gromos/omp command -============================== +bond_style gromos/omp command +============================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style gromos @@ -18,7 +18,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style gromos bond_coeff 5 80.0 1.2 @@ -28,19 +28,21 @@ Description The *gromos* bond style uses the potential -.. image:: Eqs/bond_gromos.jpg - :align: center +.. math:: -where r0 is the equilibrium bond distance. Note that the usual 1/4 -factor is included in K. + E = K (r^2 - r_0^2)^2 + + +where :math:`r_0` is the equilibrium bond distance. Note that the usual 1/4 +factor is included in :math:`K`. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/distance\^4) -* r0 (distance) +* :math:`K` (energy/distance\^4) +* :math:`r_0` (distance) ---------- @@ -82,8 +84,3 @@ Related commands :doc:`bond\_coeff `, :doc:`delete\_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_gromos.txt b/doc/txt/bond_gromos.txt deleted file mode 100644 index e039e6c411..0000000000 --- a/doc/txt/bond_gromos.txt +++ /dev/null @@ -1,72 +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 - -bond_style gromos command :h3 -bond_style gromos/omp command :h3 - -[Syntax:] - -bond_style gromos :pre - -[Examples:] - -bond_style gromos -bond_coeff 5 80.0 1.2 :pre - -[Description:] - -The {gromos} bond style uses the potential - -:c,image(Eqs/bond_gromos.jpg) - -where r0 is the equilibrium bond distance. Note that the usual 1/4 -factor is included in K. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^4) -r0 (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From 4a1e9d9483005761f68ff0104d38ddbaff259de9 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:19:57 -0500 Subject: [PATCH 455/557] Update docs: bond_harmonic --- doc/src/Eqs/bond_harmonic.jpg | Bin 1861 -> 0 bytes doc/src/Eqs/bond_harmonic.tex | 9 ----- doc/src/bond_harmonic.rst | 41 +++++++++---------- doc/txt/bond_harmonic.txt | 74 ---------------------------------- 4 files changed, 19 insertions(+), 105 deletions(-) delete mode 100644 doc/src/Eqs/bond_harmonic.jpg delete mode 100644 doc/src/Eqs/bond_harmonic.tex delete mode 100644 doc/txt/bond_harmonic.txt diff --git a/doc/src/Eqs/bond_harmonic.jpg b/doc/src/Eqs/bond_harmonic.jpg deleted file mode 100644 index fe9ef5619b328950e68963d0e1b731119eb8ec3b..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 1861 zcmaJ?c{JM#8vR8QiAPIF8+#gw+D+-B%7{TNiB~C+ww6*&w1}m)YC}jJOVb9i46i!W zI)sL2iKU8CYpX5gNog=epITaNg<2jNJ!j7RH*@bf_n+@O_dEBW`$^tP{skxy9SM#A z2m}J04+u!!0rmhC41qwv&;x-&q0%rpIP3uOva&LA2zf1@9RBS3D>d8TX^IfX zzis^n95H)Sn{EjsXfB>%Bv5huI$pKz1!hoys)m=E%e}mBJ>EnLUy)R7g!6cYAdC(USat9|M`t%h=&;rp{=K%wFF9ic*^6H5a)@=l8@PDHD~&fqYN#)60`+ zKO(+VTX7y2WO)8!-*13JO-xyJDxUh#C+|DHlYOdKMhr7+qoi;S;}@p9K1{igIn856 zAGadLkF}MSr$DqFXt6r}xRCH$VDjK+?1txzJgsVMlAh}CkskTr|P`;XMSXZBYNo}(}ACi9*48pA6^nVFQ9K1PJ& zN&~I8M&`OPb~xEFW6In3Qy`E%SK!)_(7US~~hp zdc{i+RF1)&M)Vo!MOUGVC4gbkvyCOf2##wgA}-ZB_0#KqO*2&^&sT`+P3ltD{p}fE z%nU+nvPFvdoO_e5LU~n)0y85D4-Sa+9BbcU1ovI?ig-XUJEz4LH~EC>6X#QmXn^7~ ze#qLOQ>NPk>l4(RmN-)fp*+Q|qQU1O^>~~j?rgjsrkpj3IaC6Ds`Sy^tigkHrvGHp z##+|bceRz`**iAOiz4`inwHj>NUj>EDm{CQq+5vN2V3?5@9c?jf81x{_cXxh=%yZA}{$q)ze|1nz#jr`AK8D-zg; zW6=$+p4)}x3}cKD9wOCyXSOwzJ;8;T&`?Rev*{vi`E`-cks*r~XFk1%jd$Z*wNd7^PlNELNd8QOtK}|>PVJz35}Ao`VO8#2bcDsMMhZd3 j)u@WUnXhi;U4!F=>F)A~`ffG_8N~nlSvXV`$>hHQIt*An diff --git a/doc/src/Eqs/bond_harmonic.tex b/doc/src/Eqs/bond_harmonic.tex deleted file mode 100644 index 2461086898..0000000000 --- a/doc/src/Eqs/bond_harmonic.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ - E = K (r - r_0)^2 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/bond_harmonic.rst b/doc/src/bond_harmonic.rst index 4718656b91..d65f0337f0 100644 --- a/doc/src/bond_harmonic.rst +++ b/doc/src/bond_harmonic.rst @@ -1,22 +1,22 @@ -.. index:: bond\_style harmonic +.. index:: bond_style harmonic -bond\_style harmonic command -============================ +bond_style harmonic command +=========================== -bond\_style harmonic/intel command -================================== +bond_style harmonic/intel command +================================= -bond\_style harmonic/kk command +bond_style harmonic/kk command +============================== + +bond_style harmonic/omp command =============================== -bond\_style harmonic/omp command -================================ - Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style harmonic @@ -24,7 +24,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style harmonic bond_coeff 5 80.0 1.2 @@ -34,19 +34,21 @@ Description The *harmonic* bond style uses the potential -.. image:: Eqs/bond_harmonic.jpg - :align: center +.. math:: -where r0 is the equilibrium bond distance. Note that the usual 1/2 -factor is included in K. + E = K (r - r_0)^2 + + +where :math:`r_0` is the equilibrium bond distance. Note that the usual 1/2 +factor is included in :math:`K`. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/distance\^2) -* r0 (distance) +* :math:`K` (energy/distance\^2) +* :math:`r_0` (distance) ---------- @@ -88,8 +90,3 @@ Related commands :doc:`bond\_coeff `, :doc:`delete\_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_harmonic.txt b/doc/txt/bond_harmonic.txt deleted file mode 100644 index 3afdf4ceba..0000000000 --- a/doc/txt/bond_harmonic.txt +++ /dev/null @@ -1,74 +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 - -bond_style harmonic command :h3 -bond_style harmonic/intel command :h3 -bond_style harmonic/kk command :h3 -bond_style harmonic/omp command :h3 - -[Syntax:] - -bond_style harmonic :pre - -[Examples:] - -bond_style harmonic -bond_coeff 5 80.0 1.2 :pre - -[Description:] - -The {harmonic} bond style uses the potential - -:c,image(Eqs/bond_harmonic.jpg) - -where r0 is the equilibrium bond distance. Note that the usual 1/2 -factor is included in K. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^2) -r0 (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From 41c0d690502652bf2700092eed655e6b9fb857fc Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:27:59 -0500 Subject: [PATCH 456/557] Update docs: pair_list --- doc/src/pair_list.rst | 54 ++++++++-------- doc/txt/pair_list.txt | 144 ------------------------------------------ 2 files changed, 27 insertions(+), 171 deletions(-) delete mode 100644 doc/txt/pair_list.txt diff --git a/doc/src/pair_list.rst b/doc/src/pair_list.rst index 3a161fb408..b74070c4d3 100644 --- a/doc/src/pair_list.rst +++ b/doc/src/pair_list.rst @@ -1,13 +1,13 @@ -.. index:: pair\_style list +.. index:: pair_style list -pair\_style list command -======================== +pair_style list command +======================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS pair_style list listfile cutoff keyword @@ -19,14 +19,14 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS pair_style list restraints.txt 200.0 - pair_coeff \* \* + pair_coeff * * pair_style hybrid/overlay lj/cut 1.1225 list pair_list.txt 300.0 - pair_coeff \* \* lj/cut 1.0 1.0 - pair_coeff 3\* 3\* list + pair_coeff * * lj/cut 1.0 1.0 + pair_coeff 3* 3* list Description """"""""""" @@ -77,36 +77,41 @@ Here is an example file: The style *lj126* computes pairwise interactions with the formula -.. image:: Eqs/pair_lj.jpg - :align: center +.. math:: + + E = 4 \epsilon \left[ \left(\frac{\sigma}{r}\right)^{12} - \left(\frac{\sigma}{r}\right)^6 \right] \qquad r < r_c + and the coefficients: -* epsilon (energy units) -* sigma (distance units) +* :math:`\epsilon` (energy units) +* :math:`\sigma` (distance units) The style *morse* computes pairwise interactions with the formula -.. image:: Eqs/pair_morse.jpg - :align: center +.. math:: + + E = D_0 \left[ e^{- 2 \alpha (r - r_0)} - 2 e^{- \alpha (r - r_0)} \right] \qquad r < r_c + and the coefficients: -* D0 (energy units) -* alpha (1/distance units) -* r0 (distance units) +* :math:`D_0` (energy units) +* :math:`\alpha` (1/distance units) +* :math:`r_0` (distance units) The style *harmonic* computes pairwise interactions with the formula -.. image:: Eqs/bond_harmonic.jpg - :align: center +.. math:: + + E = K (r - r_0)^2 and the coefficients: -* K (energy units) -* r0 (distance units) +* :math:`K` (energy units) +* :math:`r_0` (distance units) -Note that the usual 1/2 factor is included in K. +Note that the usual 1/2 factor is included in :math:`K`. ---------- @@ -161,8 +166,3 @@ Related commands :doc:`bond\_style harmonic ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/pair_list.txt b/doc/txt/pair_list.txt deleted file mode 100644 index 9500a4c508..0000000000 --- a/doc/txt/pair_list.txt +++ /dev/null @@ -1,144 +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 - -pair_style list command :h3 - -[Syntax:] - -pair_style list listfile cutoff keyword :pre - -listfile = name of file with list of pairwise interactions -cutoff = global cutoff (distance units) -keyword = optional flag {nocheck} or {check} (default is {check}) :ul - -[Examples:] - -pair_style list restraints.txt 200.0 -pair_coeff * * :pre - -pair_style hybrid/overlay lj/cut 1.1225 list pair_list.txt 300.0 -pair_coeff * * lj/cut 1.0 1.0 -pair_coeff 3* 3* list :pre - -[Description:] - -Style {list} computes interactions between explicitly listed pairs of -atoms with the option to select functional form and parameters for -each individual pair. Because the parameters are set in the list -file, the pair_coeff command has no parameters (but still needs to be -provided). The {check} and {nocheck} keywords enable/disable a test -that checks whether all listed bonds were present and computed. - -This pair style can be thought of as a hybrid between bonded, -non-bonded, and restraint interactions. It will typically be used as -an additional interaction within the {hybrid/overlay} pair style. It -currently supports three interaction styles: a 12-6 Lennard-Jones, a -Morse and a harmonic potential. - -The format of the list file is as follows: - -one line per pair of atoms :ulb,l -empty lines will be ignored :l -comment text starts with a '#' character :l -line syntax: {ID1 ID2 style coeffs cutoff} :l - ID1 = atom ID of first atom - ID2 = atom ID of second atom - style = style of interaction - coeffs = list of coeffs - cutoff = cutoff for interaction (optional) :pre -:ule - -The cutoff parameter is optional. If not specified, the global cutoff -is used. - -Here is an example file: - -# this is a comment :pre - -15 259 lj126 1.0 1.0 50.0 -15 603 morse 10.0 1.2 2.0 10.0 # and another comment -18 470 harmonic 50.0 1.2 5.0 :pre - -The style {lj126} computes pairwise interactions with the formula - -:c,image(Eqs/pair_lj.jpg) - -and the coefficients: - -epsilon (energy units) -sigma (distance units) :ul - -The style {morse} computes pairwise interactions with the formula - -:c,image(Eqs/pair_morse.jpg) - -and the coefficients: - -D0 (energy units) -alpha (1/distance units) -r0 (distance units) :ul - -The style {harmonic} computes pairwise interactions with the formula - -:c,image(Eqs/bond_harmonic.jpg) - -and the coefficients: - -K (energy units) -r0 (distance units) :ul - -Note that the usual 1/2 factor is included in K. - -:line - -[Mixing, shift, table, tail correction, restart, rRESPA info]: - -This pair style does not support mixing since all parameters are -explicit for each pair. - -The "pair_modify"_pair_modify.html shift option is supported by this -pair style. - -The "pair_modify"_pair_modify.html table and tail options are not -relevant for this pair style. - -This pair style does not write its information to "binary restart -files"_restart.html, so pair_style and pair_coeff commands need -to be specified in an input script that reads a restart file. - -This pair style can only be used via the {pair} keyword of the -"run_style respa"_run_style.html command. It does not support the -{inner}, {middle}, {outer} keywords. - -:line - -[Restrictions:] - -This pair style does not use a neighbor list and instead identifies -atoms by their IDs. This has two consequences: 1) The cutoff has to be -chosen sufficiently large, so that the second atom of a pair has to be -a ghost atom on the same node on which the first atom is local; -otherwise the interaction will be skipped. You can use the {check} -option to detect, if interactions are missing. 2) Unlike other pair -styles in LAMMPS, an atom I will not interact with multiple images of -atom J (assuming the images are within the cutoff distance), but only -with the nearest image. - -This 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 on for more info. - -[Related commands:] - -"pair_coeff"_pair_coeff.html, -"pair_style hybrid/overlay"_pair_hybrid.html, -"pair_style lj/cut"_pair_lj.html, -"pair_style morse"_pair_morse.html, -"bond_style harmonic"_bond_harmonic.html - -[Default:] none From fed5d07aa7405f7c9874fce38d4fba0d3b9e267c Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:36:17 -0500 Subject: [PATCH 457/557] Update docs: bond_harmonic_shift --- doc/src/Eqs/bond_harmonic_shift.jpg | Bin 5078 -> 0 bytes doc/src/Eqs/bond_harmonic_shift.tex | 9 ---- doc/src/bond_harmonic_shift.rst | 37 +++++++------- doc/txt/bond_harmonic_shift.txt | 76 ---------------------------- 4 files changed, 17 insertions(+), 105 deletions(-) delete mode 100644 doc/src/Eqs/bond_harmonic_shift.jpg delete mode 100644 doc/src/Eqs/bond_harmonic_shift.tex delete mode 100644 doc/txt/bond_harmonic_shift.txt diff --git a/doc/src/Eqs/bond_harmonic_shift.jpg b/doc/src/Eqs/bond_harmonic_shift.jpg deleted file mode 100644 index 3e66d853a5173e56376b35bc8fe6b46c7732274a..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5078 zcmcIIXEYpIx1*OR(W3`57-L))8BwA~83dyn zm(u`k01Xv2H8mB@6{4Y`p`~M@r@I2yYu6Z<*jU-w*;v`wIJgCPI5_#Z*w}7}+~5-w z6c!fd;1LCi3IPR#goQ3&1Fq2n5ESJU6l{RYet-ag0zh@e;)=-y+v;ryaB@B0aq|f8% zmFsPLXI?hj`0+d>V&!QeXnT0nuqnEfZkNm0)5{U^*lyv(ATP+bLaZtXY)G^RUklWs z)Pj?+RdFG(5N}17jazf)PaWlup$YuHwzGc{M&P+E@?bNomMppANf16j;$_@oq^F(o zO7KQ`?qASkQe*mw6^~uwo{L2~3t~Fjx6IRoJ+pLSk>U98P?LH?8HK6gY5G`5a(9$1 z)^AsS;|0|U=w?t(9=F&0Ks{xkXvy6m4)B`*_Sim0o3_dlPQW6>z z^Tc{EJUuXV0x1CJ(of>&!~&AGdLl#*I_OgB%PTss7y^av|nUl|~e zQU)c4?s|M9Asgkea!@g~r!p`+%e>y~q7i+vm*-PA_@}lP!W5IXVRjQhmv?K0$KL7^ z;Cw2s`_^X{s~(l_lkOJ{g;|xWK>I5UpO0slJl{xC(_r@^*NpKLq2gUlx4!bE>UIx? zt-3T+Cj01k`ZY~u#91IJk)FWE({0)0@3o)nPr13$C*AGljv#d#vc08ZkZ7|7EIhmw zkp?#dwN4?>xA2lj2KBf`jh>a;pcg`?)hmioL!$Bl+EC%Ou^-(|W)D9l?M}hD=IwLp zO(AU-3o{;v{B)ty_b0Pe;48BNY`Nw=(#x>yC0HG^*x9%hXDLU^vDo+*=*9RZ+ppd? zN4*Sc>hbjc{hwC`qfd4o&0`;8U6ogUeRgwN!CeBRCP$-jJM7=(qQYaulHzyb$TP84 z4rfCKX9IWQ@e>?%o08WU|EU(#JCnxOF;2}xFBXbxTiz<&E>?YOz7ew{ziukwsMW}; zc+TniNR)9!%NZ5tmJwer0zBmsr09i?IdA5Ow0PteB&>=Vy8^w;?92q3e(>-;|FjW5!8nzo|1P348qZ1|UB ztK#-VsGTfvq|17S9=Ov9GUczK|^Eck4KX zJ~_{y_9uMq1T)cvm+71sfT@ej%Ps*Klvs!DuyY-dafhLwbVvqz>6y02kfp@> z1^*?$^z9{p6#KI}ETxUV%h(9wJEu_1NS*Nc-Vl`s5x4$dPCYAyoO7(16`S4l^VMK= z2j!k)!7?vD_*%@oU&PUM-P6wNQ3~X7uSNCLXx9c8XB#G)^iI6IH)_Oi&3I9B25@0y97l{ATy;*I352Z5zU1){P<0dr@g64D;R0)gkOWdQ?GRDZFC?}(}b z2i&zxmpnrmYz&hY%QyXX9tn4L60=gWNGd*2uf$ajdya?GNm;q6Wt$j52NN6pJ{8)cKhb>E&ea=n9k*?*= z0)Bf3{oe6C1NGDLqBuDpCDTqfj!hO@nFgn4yw#4<2^yaLw=DqIsMBIrhofGLMIX_o zHROzQxs%nDz-YwCU0UN#L{$8&vziLyiI3QnUOy@}p=y6Tm|S>ozbDO74b-Cvv-~SG zCHD>KNM{ha@)1tw20kn6>3GO@uPOHaAD4h?X{YTk5D&O@LKN<|)};2--pYyt<~*MB znHvv*=UQ4NeS1_m)$g%^d|HtO{y95!6~-jL>}lUkhYB~CEf_D^%UdOvDMG66L&hxm zvKuVmB?u0`AjT-%>V=9>=r@*IFuxTUmBPUIPe8e7*i+7OawEdvu=?12TSn6kiYOh( z)?e7n9gc3C@A;fnTsVE!=MVSf#js_7VD~3#wmwYB450cl^+D(} zhH+mg!ip|-x9FR7Xnf~FE(*uE`l)+WS~fnzA{f#Ef{TFlDesX=^(k($8vrPc;b#hi zYQzth0N&YNd6P1u;4SG-dj-=63jZJTX2>_c)65FCiXY^jyBdR5#t3CqX) z)IR=t_@Hj*iCYC=%dcX?B`C_0#no|(^D_IaOMvIE%*N(rn4+DLa-T=@yCCD2(PQ2m zrl@D`P9S?kc^ur(?bx1y8uF2EWjgZnsI`4>CsWN&{QQdjqhD;N1>6K=%2YvUmunOI zRMeQAkObRtA>YNVCg-8H8_a6y%qK*C!$hDj!~pQ*XKKXYd;GP$_y$J_~}Q#4%bItw1-^uDMubS6=jQz&zL70@;ZFXej{-o)S}OzaRRzYu|^Z{ zpW;IT<1kNC*O(uw)XTmTORgXO4cq}LVw6#IPx45k3_)+kyQ%8U4^F zfuoXDGr`aoJ(F1zu}9vuGKDsxMlMKeCj33QMSG1%Xs2>KB8)PlgGNfQ3#;*DS(B@- zmKBb0xnH2ws;qDj0Y)nx=EndZvX>nDzl?pvY_-HTFuuZrnL&R-@$fh6G!IfJ8-!`f z6^iXFZ7z%rg5T#g+e57q#AHI}wwDr7Tv7{+ND~PGyOwZRoH_nMLG?{aeXielI}N%t zBi6$@xW7+eez>)6SWptY!F&8taCp8|YgQn?;JbH8NoW^XZM1i!^7o6h9-~2e#c;Oe|mJgq-m zD7i|Oto$VgE<%Pj^MJgmeO9rs5OWl<4$UMkI*`y{Amk>fm$xq+Q7`LlsXoP7$ z^SUVvET=9J`y#3Tqh=U^sa>8{NX%Z;F9p8|sXr=TthadhtFWkS;+|8Rh40KJ+ zjltl{SkQS&hdi`(1-4$>-=XAgbY(+>t4Lggx6ZUR)if8yQ%c0jqHE^$ctS94@v1 z$>Vm1IPMQ#8iWM%h$121fht;RXCbh2tDPOOjRk{8W5LYFb8#Agh!^Ls&F_PyiZHWC z=Hb9hS`LBJNY(pQRcJjwKM35aJ02-)@uIBO!&bdXHkOqA+wp^}=6|K5*gt+Z+x!(Y zVjJAFJPno0zXY(WV_~7^n92DaF0-+Fjg9M5hhg4A3Je@aKNTd#KT)7x8_1~YGh@P zx7lT`#={+l0hy4B77H zc?k(B_ot&OPpHBJSE zzNbBqe@P*(lfx8W)?15iP+Yy8j&gJeo@VYbB0;9^>$MrU15bTQK)LnGk3%oM#og#TV0PH97U>{aWe&I8`FU8rk*E(bkGLCtN!va$xt9A zhqik{RE_lTdq0x7eGNp9c;=$9^C~kn27SUBgO2*TxG%)>@j^mKd52JhyWsNudo9IE zUbS(>mZ?2JwAamLcyxGPY4oS2MTp}BmI^^WI6M*0bdr!#HN3d0E z1`a$S6s7wUWqPR2t(3qo{(y0;NmaYQPp6C&H|EYw zJrP{9YJ=`B4MdwfUTjBoE@qdD^={rH5z zX$cl&aOb%`@OtER?=pRDV{AnRMg#x?>wnf4(qKio?9K$=99S@J(S)_#coCYX{++HM z(1cA?Yfg2FfdVdY;@{8Dz` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* Umin (energy) +* :math:`U_{\text{min}}` (energy) -* r0 (distance) +* :math:`r_0` (distance) -* rc (distance) +* :math:`r_c` (distance) ---------- @@ -88,8 +90,3 @@ Related commands :doc:`bond\_harmonic ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_harmonic_shift.txt b/doc/txt/bond_harmonic_shift.txt deleted file mode 100644 index 23d3dcb5d5..0000000000 --- a/doc/txt/bond_harmonic_shift.txt +++ /dev/null @@ -1,76 +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 - -bond_style harmonic/shift command :h3 -bond_style harmonic/shift/omp command :h3 - -[Syntax:] - -bond_style harmonic/shift :pre - -[Examples:] - -bond_style harmonic/shift -bond_coeff 5 10.0 0.5 1.0 :pre - -[Description:] - -The {harmonic/shift} bond style is a shifted harmonic bond that uses -the potential - -:c,image(Eqs/bond_harmonic_shift.jpg) - -where r0 is the equilibrium bond distance, and rc the critical distance. -The potential is -Umin at r0 and zero at rc. The spring constant is -k = Umin / \[ 2 (r0-rc)^2\]. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -Umin (energy) :ul -r0 (distance) :ul -rc (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the -USER-MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html, -"bond_harmonic"_bond_harmonic.html - -[Default:] none From 7aa74ac250f38bed0127343a20950dfe06814d96 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:53:38 -0500 Subject: [PATCH 458/557] Update docs: bond_harmonic_shift_cut --- doc/src/Eqs/bond_harmonic_shift_cut.jpg | Bin 5184 -> 0 bytes doc/src/Eqs/bond_harmonic_shift_cut.tex | 9 --- doc/src/bond_harmonic_shift_cut.rst | 37 ++++++------ doc/txt/bond_harmonic_shift_cut.txt | 77 ------------------------ 4 files changed, 17 insertions(+), 106 deletions(-) delete mode 100644 doc/src/Eqs/bond_harmonic_shift_cut.jpg delete mode 100644 doc/src/Eqs/bond_harmonic_shift_cut.tex delete mode 100644 doc/txt/bond_harmonic_shift_cut.txt diff --git a/doc/src/Eqs/bond_harmonic_shift_cut.jpg b/doc/src/Eqs/bond_harmonic_shift_cut.jpg deleted file mode 100644 index 06640e4fe0899b858db74b9e9297879ccdb50421..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5184 zcmbVPcTm$!xBi6^Ksrc=Py(Vfr8fyklp+eR@`_Rfr2B>*q!$IHNkWre6#)?t>AeVn z&_Wl2bO;c-p(7<%?>BSr_s9L`e$URF*_l1F=j`sYXU;>$lji}JyE^(h00;yE^nMS3 zJO#i3YDy|9DoX0#hMJlhOv6A+^Bc_c^mGiY%xr9|%&e^Jocvtumw7o@S-FL|c?ARn z1qIo;L_|d(qWlm+2)PZQrv)rQ1t1VBK*j+400^L<{1fAUKnTJ@wdw#Zz^h5Fq<$9yX>t8&n|OtiO4-l9;4+{)VA@KSMqpORqYuXpELp$ zRe=9(@;LF``*O@E`3FGzCxj+&o*em~;%$oWPVdQMo_b6X$$Xy&8RszHsnndVV?C}} zG-CAiFiSSq`?xsU_>I}atGUeqXv=e_FZTbGZfIXa5 zeCYZtI4iU2XN7*6$@@?helz+!ptON1{T@vN z8QI(A1Nj)=^UUI`vf|yhMkngLK?GT}`;pV>BQk)|Fm0b`KSWk?J^Mf$Jhu~@@#Z`K zDQ6$isX7Udui-NNt~Pm&MY4o_Wg2g4)AgPLq<|S*IH5BI z(0zPQN)0dMMFx22mip5gMy#hI`|cZvCF7RL>uR-+$N(-jeXXQ-g@Wp32hVdvjoK}N zhUlX#`K6o4`P7@zo3CTbA48E!qV=MoW;j#{YD6JBXKi*M0azOi^I}T*`}U(97FFt5 z)z_i3>U>sEPu#CD>(I_hOSzMLXX^$XtT6Dxt9DczZ>=N(AEeeH@}Cpf4J8KS1`t|z$L{T4#uz)nm@RzZvQv#EL7fJv!b`R{b)_y&&20? zuA~v2pGas*WrF*euJB0;`r*mIJCjLE zgGw%)NpAk}y2x`coiS`gTFK!*;RXk>>_$BPXdSa44(GJRcod^_{1@rx!|VIdib@d? zk3IF9Af1i)K(QM8V7~!7 z^SEv$D1&r3JEQ-mxGOQH9$WOo&3Jmzu+b}2dxE4Ht(@r|7{QTnN`wbuCYSAk>@bs0 zPIyXVYsTv{=3GmU##6H0FgDAab)y9hi0|zVBE4$h&hlr&vWrS?wjUL@5$DW!%0Es2$<7&DF&k~cr6lqC!ub#p=n&f+dV3`%WeWG>?A5*tAG2B`TMlm)Ro%u zeF(I3LCvO7TnG2o$lCWcI}wjRRK@tn1n6K5zE%8APUHk?kh)U6{Y>cP%7*Qt^5kP* z2iMNEUEiC0cwV$v3(0H{qi!I0b?gQyp5N}gG`Jt%!Eq$cwo1Tg0 ziUS7R--{9oBNh=E(D4pdGk-L9k9RK@vv6=>boX*Fl<`GK- zVryTe!q+$z|Jwd{8rx(*w?K~WkVaBRu24QK!FCsCj(03u=KlJ+Dv;qUd)C7Q)Aw&(hM7v@ zhh_rQ%)I|LN*g2tn--2_;ISqdNRRv0n9$${3kYN9f2#S{Xu57)WAJPN`o}}AP3&FN z+e9VDJ5+{ATj5+dVMadT5^I@&MsLI|(L*5V;V*-w9Pd5NZ)t9Q;v-i4r?qJp41K|- zu!Q5)nWn*?4(7W(`zcu1)=Eg2++4EJ#}?HiH~BN3zeq&9lUEwDdOY zEAMRAAye^%OmO!%G9b6u+Syfo(<2}Ud!w%7oXH?z@$(?*?XpKR?g9(;$_b0EUCryh zAG<4?!0nj)1iuzud)a=eAL&iI&aggVJ7-Si;<>|AiX3>ca2^cTO{$1YQIszq2-0cA zbzwblZW(J6&<}2U?nA>=p-W@x6a|f#FKQE@ zk>t2@B)BX)5DQgF*41Ty$@^Nq7r(s)UTdpMbip_{EFJe72@>k{ed9j_nELuqhoJ~v@PpWRdxE{O3D~Yw zPH!GH@JtwG%L_iM2{=_Wlfk3&RkwO4v-o8jbR(a6l?mtBDaKF_Xf!J3CK5psdH+Tf z^HfXZn?Aw<_ECP%Qo0TNsauTQKNtnNUn6~#Pv(pe;R6vxmj*sTD7#M~0-92XC&`|w z7Fj)7n-;52Gx8gc6%_O4hl%ffXW?lMH+2Y2RtGOTA9F;1IE~#+UDb`xG=SzswJ~b* zEIa#nhk4Cg=o6dnesPH9!5R}(Rd&;y5Y@@sy0lT1dNe-Z*!x9y%m$EwN_^rnYBMqh zQp4aBwH)4V^Tna;bqe)5 zK1QA$64+jPcfeo|CFw`Igz1vl_NJ*WWmyaJ)EHd%d6rAJPg%9it{mIfGNx!3U-P^h zT5ajn@7caMv~r+uG)!ZS#^Mc=3~hImc;yPW&yh=I=8IKfxK-| znN5PYbO#zOW+qDnzBv9Ot5}p z;TT)ff$?_JO~@W2Y3niHsG2~1FwELdVFOLrd%u5JeMylx`sV9+8M{rm(l1#QFG9Bs zpcuz3xKH->mu6swdfKoD73xW8@@8ACW0bD|Vti|Kn6PGv7!=6Vfgll~b15iaE5E^U>dq5&EUqzLHpG(!@%f z7dfGk?)lE2aL6j3Zs1y+EGx)xU=O9iK9e?#W+ZKLKNQ)4zXQI zQ}eKRsW+SA=Xpb;5zSz8 zRDm(aw3)5g5aGr}d6j+Kyid;w?C0w)tQ?vhu97}z^JP68hWvZM=rzYz2*YT(2i2dY2Sf9YCWAuo^tga1y6VFy%IKKuJ4Pg&j2snqNDL{DD z0M$#{tLEBQ5(qpYQ*C#N5sq3aRXvAU?MaRk6{u~+g9H> z$c+|9Og0B_EU>aZ2oyx&(-gRFpTsgmRS?Ir@lE(et*^&fkMfD( z9gE>V;_0uZ8*v0bpGeiHkdG$^srcG;JmP!AeKOFW;283yy1w=Xp$?6}em(x-wZcT7cho1zGo&ZdZpp<9Z?uV_GG*h=&-qUWPg}1)g((#%-HgF2MetXq;NbrhSn8)GPLGYlPXX$bMDU{}{ zFPaQ+@z$3za9;VsnNjpWPN^(?wUa)prcGeFJbMVY8Gf`j8=lS!{v{$J&0oXEoWdGY zBZ1bs(<){5rN>_xzwt@H?MKt{&;4CrWMn2x?K-1fTsxfi7+a!iRi|qMu2IssG-qqp z1(tnZ>NEs60WBXyr0L2P?FMe8Jx`E~zfI&P&b(L9ZG~g2Xo9SRZp}tAxqJT_>V4)u zY07iOm|c5s={Z8cp;AB3fwfY4TM+j94@&ckp{9A#iyQcr2OlSBf2?Zk z1T^GGP8(z&H6CTIvgscsH56qFlL7N4l?%I!vqF(CPJe3br(l7~m6o7E_lM_??)ZP_Akb=TTIc10CsFx}0JGKQ^O{YZP@D+$QAjOr7$!p(8{O;&R#g428G2mw*@@ zkg1v>10SD^hy6qZ(|-_=a75u_c7%TZ)~rh&QF5w!e0r`rUzM&|;#a(^qJ?xOqfCkBKD+OhXu@=zVFP)ZW4SF_ zMD;I;{x5sS%8h#16=f|j&B&?Gp z1(qk^3h(N4{JmZ3GnuR>8NarSS>=?s4Ex9wk9U$fxKR=tZ#FQQIaw>J-5gY#U!9Bh cu+?oI01f!;JkJ}>rThEekNF?Zt;m!A1 rc. The potential is -Umin -at r0 and zero at rc. The spring constant is k = Umin / [ 2 (r0-rc)\^2]. + E = \frac{U_{\text{min}}}{(r_0-r_c)^2} \left[ (r-r_0)^2-(r_c-r_0)^2 \right] + + +where :math:`r_0` is the equilibrium bond distance, and rc the critical distance. +The bond potential is zero for distances :math:`r > r_c`. The potential is :math:`-U_{\text{min}}` +at :math:`r_0` and zero at :math:`r_c`. The spring constant is :math:`k = U_{\text{min}} / [ 2 (r_0-r_c)\^2]`. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* Umin (energy) -* r0 (distance) -* rc (distance) +* :math:`U_{\text{min}}` (energy) +* :math:`r_0` (distance) +* :math:`r_c` (distance) ---------- @@ -87,8 +89,3 @@ Related commands :doc:`bond\_harmonic\_shift ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_harmonic_shift_cut.txt b/doc/txt/bond_harmonic_shift_cut.txt deleted file mode 100644 index 13ccb5843b..0000000000 --- a/doc/txt/bond_harmonic_shift_cut.txt +++ /dev/null @@ -1,77 +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 - -bond_style harmonic/shift/cut command :h3 -bond_style harmonic/shift/cut/omp command :h3 - -[Syntax:] - -bond_style harmonic/shift/cut :pre - -[Examples:] - -bond_style harmonic/shift/cut -bond_coeff 5 10.0 0.5 1.0 :pre - -[Description:] - -The {harmonic/shift/cut} bond style is a shifted harmonic bond that -uses the potential - -:c,image(Eqs/bond_harmonic_shift_cut.jpg) - -where r0 is the equilibrium bond distance, and rc the critical distance. -The bond potential is zero for distances r > rc. The potential is -Umin -at r0 and zero at rc. The spring constant is k = Umin / \[ 2 (r0-rc)^2\]. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -Umin (energy) -r0 (distance) -rc (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the -USER-MISC package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html, -"bond_harmonic"_bond_harmonic.html, -"bond_harmonic_shift"_bond_harmonic_shift.html - -[Default:] none From 64c31b377eb681255d0e31aedaf0483e221bb798 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 19:59:59 -0500 Subject: [PATCH 459/557] Update docs: bond_mm3 --- doc/src/Eqs/bond_mm3.jpg | Bin 5814 -> 0 bytes doc/src/Eqs/bond_mm3.tex | 9 ------ doc/src/bond_mm3.rst | 27 ++++++++---------- doc/txt/bond_mm3.txt | 58 --------------------------------------- 4 files changed, 12 insertions(+), 82 deletions(-) delete mode 100644 doc/src/Eqs/bond_mm3.jpg delete mode 100644 doc/src/Eqs/bond_mm3.tex delete mode 100644 doc/txt/bond_mm3.txt diff --git a/doc/src/Eqs/bond_mm3.jpg b/doc/src/Eqs/bond_mm3.jpg deleted file mode 100644 index 2c17739db57e8d147166ab0a4cc768cf80f534af..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 5814 zcmcJTcQD*vyTHF|mDNj@D61|(M3f+UjULf^iO$;JM(;!?RwoET1kp+Kl0=D~=q;>n zB?PM`f?%)T``)?l%$+-T?!7bjIrE(J$9d+=`J88-=Q;D>=kTiljh33G8UO+T0O)!E z_ys@(fDjXt5EDU2NJvOYA!HO#N(ypv3MRT6)KFGtb~aXK7>tAaE-wey9XJfecc1@` zu!xwL7(1_&oTRAi-Fsr9e;)!OB_*XGr(mR{WEACuaf<%01>XhGLI55DLokR7AfN?- zX+ij2fc^TOM4*2N@b3a5022}slR!wx$gd5WXaE8b7)(G2CL$svytWR#-UkS2iRd^* zl!$NW+mUd2LPaCeUPIu@b=~v^69?S)?7bpM$rx@jGBNYq;^pJNEha8;Us6h1<$qPshPQjgQJtPiz~v-+sD_>KOitDDmo@M?pZuKJ>z+1R`!dW+@j)=H>G9e z6_xc3jZMuht!?d}dV2f%2L^{ePfktG%zmAl$E>YmH@p*U9hGv-7{X zKmhokSl9DE!Tu8$?KKwxAt9KM9Y{XgZ^VMz1k3K=I9tOljr@eoBdNXdkso^ZH0PiME(WmbFI{>p>I}$)#!!D{O)>E z%t|KU<74tP3LzI4*Z4&y+rKq(lJAWRYS>(lKy%MadNu}t>Z@L>jl){mlxd&5;Me^p z%!1NW`r72&>Hc%|Md5!;CGU)O0VMhnifs9+-oNG9b%L&z@qn?pgQdqO7PCz!7&b@i zr3f}=OZ4e)MqQ|t#=ye~4nOsoyCFHORAgP~v0K!CRql?V&I&0{H#Cds)V8;RL|;ao zPE}?uoxCcV7g+qlTGNP(=%=Sw(*+lWi|Q&8aa;7~%N^9C_as`KoQ>K0q2UXtVo-VgawLjCAyqq?uaE$JTOfxUJ&WLa_JxbnF%jm@ z;i13`WTB5g23bFvTI=oLzZsO3U$bCIUY5LWZ|JeZqLQAcs}zxzHtKCXn(g=dTql1c zjj>>zFtb>p%UlV5FalT>wT{tSEG;8Xs;JSmK8)+lcOE)PXleU!p7MfI`r9elFfuw! z4=i4ur`kToc|YVvP?y8Mf#(&Wpfc6K{b;eaXH$+Hhu>e9x5eMGBrXt_X^!PYC+(7y zK5eUw>Ye)7H=9}5-=|h46Iz(u>5}BHp|GlM9|{{MQG&&bA-NybCW=;}@7vXoN`_jrA9?MaiPN1kZd!<<~FfRef2kc3mI}@kZf&x@z4VFdyDr;JqqT z52Q*Dn^JctAGsHuL~Nd7r%0!7{`eq$YuQ5c@-;($n2_v6(uY#^l+=Bqr+;}tb}Sl! z6%pALfuOS&OD(e4uWZk^H!o}*8z#7CanJK=_*mX7%wTPtQWizQ1LcO(WJ_qH0%(>5 zB}=)J-6ES(A<2ZQ3nD0LWvINWsJ!Vt(syBz$S`C7SdTafYAUmiSYF@J8h5ZSHq7rB zSAX2l|GtF%0A44b>;^K1R2-Gdf?JQ5f;Lvct);4B zh6CSKxHNL$UczvW)x;EKNHrdy*{1uEOFz@sO1u?8Utf@PFEuR+*Orx!d=na{(loid zR}ya7n|9}O<*0Hv=~)Dmd{wZl8_S0Z`W# z0DXtC*}?dgd4}DpD6vuZ6!Y6_xh4LCRf#tH8>NRui(*CJ9Br#( zNN>L#ReI<^(iB7qKut+&&6lhLO7|Y0>OA==6HuHa8|~UG+0C6I3}XvQaa)>MLn;ug z^dZ8$tnWA;?Nju<8J$$w|1}10DT9JOS~a(=BXL5HW_>kwPRa|cTmw3)_ZXSoo?syqy)Vux zN?EVQu(t$nd+tRZn<~*KdFDC9BnwhxeQ7{yuX$6(T7@DJ#%z?vL)gE)N>@@b3Xz0w zQ`!X-U2Tu4MlLVw-o*oYt?1AEG+|W;DyD%ym8@}piW(ElTrC_u4~eR8(?SUb03X0H zqgx@Tki5~v$Kone_GG*#j3UYVs<7C}@yvf!cs0LM;@(T|$wt@f1bv;PbNA}{M|bI= zbi)GxXmQr^^p&c1AaAHLPcqkoHbTa_NbN)?MT#Gd|sl#u;ZSL-ka@l zku|;_*|mcg-oFpnNS<+gfEgzCvVI=&VZ()&@ppL$C;f%m>GD=KbMWUO_?WM(!H6&a zpz|#W+v|TH%+`aL2nhLcsKq^b1>c^v2uiRt8@A+(+fW_Wcm%9^Xt#Y@LXmBy)^g!AW&I@Sjg<;(UujyIPNhn;3Jpd#u9BY11nwNAOP$ZgKtZ}D(_E8c!An|RgeIx7 z`x)~_uYTCLudRRvYC>2nEk9Wr%m`wBIeTAKB3MS0JC`<}1i!Q`AeMvcP5La^@FW;a z;e;FvGqqosC{n+(MW7mMq(}RzQGW^AHrT3I_K{UP(ngX+B&!1U0VKUT>tQ73k9GUD z!R`TZm5*KtM9MfOUP4ND0w1%T8t3ha+Nde4h*Yo_HT{KXr%EYqXwEK~n`?}sLZK$P zR;&x13lE8N?!HF2ii=R7!R-#UeQlkBBVo$EyWo0;F#`{04ufo>g?B6Rh^{HDDH+r*a zlP2ULqtt3laQJM^IH9S?7s1AO!sQ3mt(tzsm{5pv=b5Y^SHpFy8{TQBSH50{9Kojdd1*?y?H>Uc6>nUh?!zp;&6u?u28|Mf z>oUg327yn8OLoR#jB9>Jre6naeXO~7UWK^1fol(ejq>43cGdZmhsME6e&@Q>0WFWw z>qdF%?fHWC)Xz@3iaE23pK#XeO2QetYL6K0TOuVnk{rhJ#Uz*V-yTo#dhuN=HfHKtJ`>lf!+|(gyLm*Yy`**Lt8DDTh zQv(E)&{k*hWtLT&(`toNA*xPyD{R|gwDk+i)OWY_ge%B;(b z;Y6_gQ8&|ktTL#;k~PK!4}2nB#RKQ`VhR^GRq#OX>~OP5#u=M$wP3K{1h+AnCjSM+lzh>i<+1UN;Br;;V-THORmQkDON~5sof7w^;{6ov zt%bH3{Rt@#Em$;Gmikr2uMz+I?M_**8<#Ar6T@Skr~pCX>XMQh{uL;cU^U92sWFmI z5X-1hq*qxyM+U4thpre0|))T{RN!BX7|PsS_y8I{txg)!*C zd{>4lq$OE3k=QI^v@0lP5azR+I)Dokz+Fhc)MX;QKoD)3{QiyE;i_GyU{fI^RW+Y2hAZm|G(=L-tlO?gLf{`P66%Amo*tcen zP8s^K`t^~PNoo#N4|x*r?>l;Pwa87=1HTw6Z+38gWTQW1kDm-Qu@=1wSc{g29~EZU z8GNL|Rcp#7Ez(A$C?$)~39jASH=L|(sbsO~dJ7d&qfsm-pi&Z`*jeHi6U zoCX>d?q$=!dhYZAh|^LH?7`EfJJEqiI~j>k+2#@LwbPQQ9t$Ib&0%dx z^1dbFSAOo*u-jdhOG+wiozzaB-;BxVCzhM-uKv#79c1>T&Ypo&+@I?aW~Gf$R;qh@ zp2Wv3XWQy5o>OIxZnr&tcE#fSC&?+484q;6pguCWNb;pmS*Mgh4%P_WnP$0^_Vgx5 zC%z*45QuAIiVY%A!YMM}{EDzETU^!<%{mmTmU~VYmT7w-m#+Pa0AbpY|Mg~F-ca7m zH~YU#{8Rd1`KwEP)OAq=Jxa&py{og%n5ZOrA zI?@5G$M?kk zXcc_*unIQYH|?T1p<0_@N2fuOi6qpIMvDf~k&s1IoZC94l9{$@^W> zX4YEmGx?uj(kE-$?_-=}i9Og9I|ItMJct2$wbB~`os3x1uiAtM2U^4T9a0ZCi zo@7lfsrvGK5b}gLp`8`2!Mv^BJ3tr%XQ>sOmgWBbC3)gm3OpleNc^~YXU*L-`L|0q9sU1D&PDNN}LVbI747bAe zS93i)ka*)Z9>DfK^}z#dOSO5cBf9!z7V8jJRJg(sM$ticKq#fZvFVa;NBTil-5^)1 zsV43XoJ*?Mc57h4D=`_%^(KjH=I2~z;~j$h&-?DuvGZKQ@VT{cjub^zz-atJ%C2|| zBbVA3Q8L9r+ryv8pe7LKB&YPmOWkVr1A62}rToBc<>q^h=j-{ZfNhxLY1~z;`$cNX zh1tl{F(jNz;$pCDvxXi-O!))^g^NUGSevAUT~-vCxv}_#RxV4OoIlZ?Uq5wAxGXR$Dep%8}~VB3ey`jLF?zu0qO6lewO2iMijgpOsQPLlrMXZk$*CWF3`p z3@1~dij@VIv>dd{#$WBoh+ajT>g$=CcbCmA%v*A32M1*FrG}A}cd@5dY=JkfouzPO zEZ$kIaDGdg@3aRG@EBU2UoS-tMd9-A{@FA7yKnU0Yqc)aLf6|4#nX7$Bi=OaU93%; zrfGGc=p=XPS`;pXFjyQb?c>3II)1t5>cCf)k;v~1PYJs25&-)D&uVO~rv0q(tfVPm z(w7~s6*CR{4Mc{Cs6s*O9XzMj-s^8^mXM}FyZXA`EnX`2%1M<_2hkf7s!)AJcKrOm E0TN28@Bjb+ diff --git a/doc/src/Eqs/bond_mm3.tex b/doc/src/Eqs/bond_mm3.tex deleted file mode 100644 index 549500ebac..0000000000 --- a/doc/src/Eqs/bond_mm3.tex +++ /dev/null @@ -1,9 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} -\thispagestyle{empty} -$$ - E = K (r - r_0)^2 \left[ 1 - 2.55(r-r_0) + (7/12) 2.55^2(r-r_0)^2 \right] -$$ - -\end{document} diff --git a/doc/src/bond_mm3.rst b/doc/src/bond_mm3.rst index 4096a34d48..5794592ce4 100644 --- a/doc/src/bond_mm3.rst +++ b/doc/src/bond_mm3.rst @@ -1,13 +1,13 @@ -.. index:: bond\_style mm3 +.. index:: bond_style mm3 -bond\_style mm3 command -======================= +bond_style mm3 command +====================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style mm3 @@ -15,7 +15,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style mm3 bond_coeff 1 100.0 107.0 @@ -26,10 +26,12 @@ Description The *mm3* bond style uses the potential that is anharmonic in the bond as defined in :ref:`(Allinger) ` -.. image:: Eqs/bond_mm3.jpg - :align: center +.. math:: -where r0 is the equilibrium value of the bond, and K is a + E = K (r - r_0)^2 \left[ 1 - 2.55(r-r_0) + (7/12) 2.55^2(r-r_0)^2 \right] + + +where :math:`r_0` is the equilibrium value of the bond, and :math:`K` is a prefactor. The anharmonic prefactors have units angstrom\^(-n): -2.55 angstrom\^(-1) and (7/12)2.55\^2 angstrom\^(-2). The code takes care of the necessary unit conversion for these factors internally. @@ -41,8 +43,8 @@ The following coefficients must be defined for each bond type via the the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* K (energy/distance\^2) -* r0 (distance) +* :math:`K` (energy/distance\^2) +* :math:`r_0` (distance) Restrictions """""""""""" @@ -69,8 +71,3 @@ Related commands **(Allinger)** Allinger, Yuh, Lii, JACS, 111(23), 8551-8566 (1989), - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_mm3.txt b/doc/txt/bond_mm3.txt deleted file mode 100644 index c3d0e39f52..0000000000 --- a/doc/txt/bond_mm3.txt +++ /dev/null @@ -1,58 +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 - -bond_style mm3 command :h3 - -[Syntax:] - -bond_style mm3 :pre - -[Examples:] - -bond_style mm3 -bond_coeff 1 100.0 107.0 :pre - -[Description:] - -The {mm3} bond style uses the potential that is anharmonic in the bond -as defined in "(Allinger)"_#mm3-allinger1989 - -:c,image(Eqs/bond_mm3.jpg) - -where r0 is the equilibrium value of the bond, and K is a -prefactor. The anharmonic prefactors have units angstrom^(-n): --2.55 angstrom^(-1) and (7/12)2.55^2 angstrom^(-2). The code takes -care of the necessary unit conversion for these factors internally. -Note that the MM3 papers contains an error in Eq (1): -(7/12)2.55 should be replaced with (7/12)2.55^2 - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^2) -r0 (distance) :ul - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the -USER_YAFF package. See the "Build package"_Build_package.html doc -page for more info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html - -[Default:] none - -:line - -:link(mm3-allinger1989) -[(Allinger)] Allinger, Yuh, Lii, JACS, 111(23), 8551-8566 -(1989), From 3861b3cbbb32f143f85e1668bb3fac774c4f7bd6 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sat, 16 Nov 2019 18:20:08 -0700 Subject: [PATCH 460/557] ComputeSnap is working with, matching results FitSNAP3 A matrix --- src/SNAP/compute_snap.cpp | 302 ++++++++++++++++++++++++++++++-------- src/SNAP/compute_snap.h | 9 +- 2 files changed, 250 insertions(+), 61 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index c636ee8841..5c472861ec 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -12,14 +12,16 @@ ------------------------------------------------------------------------- */ /* IDEAS --Need to define a local array for snad on local and ghost atoms, in addition -a local vector of (1+6)*size_array_cols scalars. --Reverse communicate local array --MPI Allreduce on vector --Copy vector and array into output array --size_array_cols = ncoeff --size_array_rows = total number of atoms --Boom! +-DONE: Need to define a local peratom array for snad and snad on local and ghost atoms +-DONE: Reverse communicate local peratom array +-DONE: Copy peratom array into output array +-DONE: size_array_cols = nperdim (ncoeff [+quadratic]) +-DONE: size_array_rows = 1 + total number of atoms + 6 +-DONE: size_peratom = (3+6)*nperdim*ntypes +INCOMPLETE: Mappy from local to global +INCOMPLETE: modify->find_compute() +INCOMPLETE: eliminate local peratom array for viral, replace with fdotr + */ #include "compute_snap.h" #include @@ -39,10 +41,16 @@ a local vector of (1+6)*size_array_cols scalars. using namespace LAMMPS_NS; +enum{SCALAR,VECTOR,ARRAY}; + ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(NULL), list(NULL), snap(NULL), - radelem(NULL), wjelem(NULL) + radelem(NULL), wjelem(NULL), snap_peratom(NULL) { + + array_flag = 1; + extarray = 0; + double rfac0, rmin0; int twojmax, switchflag, bzeroflag; radelem = NULL; @@ -123,12 +131,15 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; yoffset = nperdim; zoffset = 2*nperdim; - size_array_rows = total number of atoms - size_array_cols = 3*nperdim*atom->ntypes; - comm_reverse = size_peratom_cols; + virialoffset = 3*nperdim; + natoms = atom->natoms; + size_array_rows = 1+3*natoms+6; + size_array_cols = nperdim*atom->ntypes+1; // extra col for reference potential + ndims_peratom = 9; + size_peratom = ndims_peratom*nperdim*atom->ntypes; // local atom force and virial data + comm_reverse = size_peratom; nmax = 0; - snap = NULL; } /* ---------------------------------------------------------------------- */ @@ -136,6 +147,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ComputeSnap::~ComputeSnap() { memory->destroy(snap); + memory->destroy(snap_peratom); memory->destroy(radelem); memory->destroy(wjelem); memory->destroy(cutsq); @@ -167,8 +179,36 @@ void ComputeSnap::init() if (count > 1 && comm->me == 0) error->warning(FLERR,"More than one compute snap"); snaptr->init(); + + // allocate memory for global array + + // printf("allocate memory for global array rows = %d cols = %d\n", + // size_array_rows,size_array_cols); + memory->create(snap,size_array_rows,size_array_cols, + "snap:snap"); + array = snap; + + // INCOMPLETE: modify->find_compute() + // was called 223960 times by snappy Ta example + // that is over 600 times per config? + // how is this possible??? + + // find compute for reference energy + + char *id_pe = (char *) "thermo_pe"; + int ipe = modify->find_compute(id_pe); + c_pe = modify->compute[ipe]; + + // add compute for reference virial tensor + + char *id_virial = (char *) "snap_press"; + int ivirial = modify->find_compute(id_virial); + if (ivirial == -1) + error->all(FLERR,"compute snap requires that compute snap_press exists!"); + c_virial = modify->compute[ivirial]; } + /* ---------------------------------------------------------------------- */ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) @@ -178,27 +218,34 @@ void ComputeSnap::init_list(int /*id*/, NeighList *ptr) /* ---------------------------------------------------------------------- */ -void ComputeSnap::compute() +void ComputeSnap::compute_array() { int ntotal = atom->nlocal + atom->nghost; - invoked_peratom = update->ntimestep; + invoked_array = update->ntimestep; - // grow snap array if necessary + // printf("Invoking compute snap on timestep %d\n",invoked_array); + + // grow snap_peratom array if necessary if (atom->nmax > nmax) { - memory->destroy(snap); + memory->destroy(snap_peratom); nmax = atom->nmax; - memory->create(snap,size_array_rows,size_array_cols, - "snap:snap"); - array = snap; + memory->create(snap_peratom,nmax,size_peratom, + "snap:snap_peratom"); } - // clear local array + // clear global array + // only need to zero out first row + + for (int icoeff = 0; icoeff < size_array_cols; icoeff++) + snap[0][icoeff] = 0.0; + + // clear peratom array for (int i = 0; i < ntotal; i++) - for (int icoeff = 0; icoeff < size_peratom_cols; icoeff++) { - snap[i][icoeff] = 0.0; + for (int icoeff = 0; icoeff < size_peratom; icoeff++) { + snap_peratom[i][icoeff] = 0.0; } // invoke full neighbor list (will copy or build if necessary) @@ -228,11 +275,7 @@ void ComputeSnap::compute() const double radi = radelem[itype]; const int* const jlist = firstneigh[i]; const int jnum = numneigh[i]; - - // const int typeoffset = threencoeff*(atom->type[i]-1); - // const int quadraticoffset = threencoeff*atom->ntypes + - // threencoeffq*(atom->type[i]-1); - const int typeoffset = 3*nperdim*(atom->type[i]-1); + const int typeoffset = ndims_peratom*nperdim*(atom->type[i]-1); // insure rij, inside, and typej are of size jnum @@ -266,9 +309,9 @@ void ComputeSnap::compute() snaptr->compute_ui(ninside); snaptr->compute_zi(); - if (quadraticflag) { - snaptr->compute_bi(); - } + // if (quadraticflag) { + snaptr->compute_bi(); + // } for (int jj = 0; jj < ninside; jj++) { const int j = snaptr->inside[jj]; @@ -279,22 +322,39 @@ void ComputeSnap::compute() // Accumulate -dBi/dRi, -dBi/dRj - double *snapi = snap[i]+typeoffset; - double *snapj = snap[j]+typeoffset; + double *snadi = snap_peratom[i]+typeoffset; + double *snadj = snap_peratom[j]+typeoffset; + double *snavi = snadi+virialoffset; + double *snavj = snadj+virialoffset; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { - snapi[icoeff] += snaptr->dblist[icoeff][0]; - snapi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; - snapi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; - snapj[icoeff] -= snaptr->dblist[icoeff][0]; - snapj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; - snapj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + snadi[icoeff] += snaptr->dblist[icoeff][0]; + snadi[icoeff+yoffset] += snaptr->dblist[icoeff][1]; + snadi[icoeff+zoffset] += snaptr->dblist[icoeff][2]; + snadj[icoeff] -= snaptr->dblist[icoeff][0]; + snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; + snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; + + snavi[icoeff] += snaptr->dblist[icoeff][0]*xtmp; + snavi[icoeff+nperdim] += snaptr->dblist[icoeff][1]*ytmp; + snavi[icoeff+2*nperdim] += snaptr->dblist[icoeff][2]*ztmp; + snavi[icoeff+3*nperdim] += snaptr->dblist[icoeff][1]*ztmp; + snavi[icoeff+4*nperdim] += snaptr->dblist[icoeff][0]*ztmp; + snavi[icoeff+5*nperdim] += snaptr->dblist[icoeff][0]*ytmp; + snavj[icoeff] -= snaptr->dblist[icoeff][0]*x[j][0]; + snavj[icoeff+nperdim] -= snaptr->dblist[icoeff][1]*x[j][1]; + snavj[icoeff+2*nperdim] -= snaptr->dblist[icoeff][2]*x[j][2]; + snavj[icoeff+3*nperdim] -= snaptr->dblist[icoeff][1]*x[j][2]; + snavj[icoeff+4*nperdim] -= snaptr->dblist[icoeff][0]*x[j][2]; + snavj[icoeff+5*nperdim] -= snaptr->dblist[icoeff][0]*x[j][1]; } if (quadraticflag) { const int quadraticoffset = ncoeff; - snapi += quadraticoffset; - snapj += quadraticoffset; + snadi += quadraticoffset; + snadj += quadraticoffset; + snavi += quadraticoffset; + snavj += quadraticoffset; int ncount = 0; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bi = snaptr->blist[icoeff]; @@ -308,12 +368,26 @@ void ComputeSnap::compute() double dbytmp = bi*biy; double dbztmp = bi*biz; - snapi[ncount] += dbxtmp; - snapi[ncount+yoffset] += dbytmp; - snapi[ncount+zoffset] += dbztmp; - snapj[ncount] -= dbxtmp; - snapj[ncount+yoffset] -= dbytmp; - snapj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; + + snavi[ncount] += dbxtmp*xtmp; + snavi[ncount+nperdim] += dbytmp*ytmp; + snavi[ncount+2*nperdim] += dbztmp*ztmp; + snavi[ncount+3*nperdim] += dbytmp*ztmp; + snavi[ncount+4*nperdim] += dbxtmp*ztmp; + snavi[ncount+5*nperdim] += dbxtmp*ytmp; + snavj[ncount] -= dbxtmp*x[j][0]; + snavj[ncount+nperdim] -= dbytmp*x[j][1]; + snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; + snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; + snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; + snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; + ncount++; // upper-triangular elements of quadratic matrix @@ -326,24 +400,132 @@ void ComputeSnap::compute() double dbztmp = bi*snaptr->dblist[jcoeff][2] + biz*snaptr->blist[jcoeff]; - snapi[ncount] += dbxtmp; - snapi[ncount+yoffset] += dbytmp; - snapi[ncount+zoffset] += dbztmp; - snapj[ncount] -= dbxtmp; - snapj[ncount+yoffset] -= dbytmp; - snapj[ncount+zoffset] -= dbztmp; + snadi[ncount] += dbxtmp; + snadi[ncount+yoffset] += dbytmp; + snadi[ncount+zoffset] += dbztmp; + snadj[ncount] -= dbxtmp; + snadj[ncount+yoffset] -= dbytmp; + snadj[ncount+zoffset] -= dbztmp; + + snavi[ncount] += dbxtmp*xtmp; + snavi[ncount+nperdim] += dbytmp*ytmp; + snavi[ncount+2*nperdim] += dbztmp*ztmp; + snavi[ncount+3*nperdim] += dbytmp*ztmp; + snavi[ncount+4*nperdim] += dbxtmp*ztmp; + snavi[ncount+5*nperdim] += dbxtmp*ytmp; + snavj[ncount] -= dbxtmp*x[j][0]; + snavj[ncount+nperdim] -= dbytmp*x[j][1]; + snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; + snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; + snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; + snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; + ncount++; } } } } + + // Accumulate Bi + + // linear contributions + + for (int icoeff = 0; icoeff < ncoeff; icoeff++) + snap[0][icoeff] += snaptr->blist[icoeff]; + + // quadratic contributions + + if (quadraticflag) { + for (int icoeff = 0; icoeff < ncoeff; icoeff++) { + double bveci = snaptr->blist[icoeff]; + snap[0][icoeff] += 0.5*bveci*bveci; + for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { + double bvecj = snaptr->blist[jcoeff]; + snap[0][icoeff] += bveci*bvecj; + } + } + } } } + // INCOMPLETE + // can get rid of virial from snap_peratom by doing + // equivalent of Pair::virial_fdotr_compute() + // before reverse communicate of snap_peratom + // communicate snap contributions between neighbor procs comm->reverse_comm_compute(this); + // construct global array + + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset = 3*nperdim*itype; + for (int icoeff = 0; icoeff < nperdim; icoeff++) { + + // assign force rows + // INCOMPLETE ignore local-global mapping for now + + int irow = 1; + for (int i = 0; i < atom->nlocal; i++) { + double *snadi = snap_peratom[i]+typeoffset; + snap[irow++][icoeff+typeoffset] = snadi[icoeff]; + snap[irow++][icoeff+typeoffset] = snadi[icoeff+yoffset]; + snap[irow++][icoeff+typeoffset] = snadi[icoeff+zoffset]; + + } + + // assign virial row + + int irow0 = irow; + snap[irow++][icoeff+typeoffset] = 0.0; + snap[irow++][icoeff+typeoffset] = 0.0; + snap[irow++][icoeff+typeoffset] = 0.0; + snap[irow++][icoeff+typeoffset] = 0.0; + snap[irow++][icoeff+typeoffset] = 0.0; + snap[irow++][icoeff+typeoffset] = 0.0; + + for (int i = 0; i < atom->nlocal; i++) { + double *snavi = snap_peratom[i]+typeoffset+virialoffset; + irow = irow0; + snap[irow++][icoeff+typeoffset] += snavi[icoeff]; + snap[irow++][icoeff+typeoffset] += snavi[icoeff+1*nperdim]; + snap[irow++][icoeff+typeoffset] += snavi[icoeff+2*nperdim]; + snap[irow++][icoeff+typeoffset] += snavi[icoeff+3*nperdim]; + snap[irow++][icoeff+typeoffset] += snavi[icoeff+4*nperdim]; + snap[irow++][icoeff+typeoffset] += snavi[icoeff+5*nperdim]; + } + + } + } + + // assign energy row + + int icol = size_array_cols-1; + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snap[irow++][icol] = reference_energy; + + // assign force rows + // INCOMPLETE ignore local-global mapping for now + + for (int i = 0; i < atom->nlocal; i++) { + snap[irow++][icol] = atom->f[i][0]; + snap[irow++][icol] = atom->f[i][1]; + snap[irow++][icol] = atom->f[i][2]; + } + + // assign virial row + // switch to Voigt notation + + c_virial->compute_vector(); + snap[irow++][icol] = c_virial->vector[0]; + snap[irow++][icol] = c_virial->vector[1]; + snap[irow++][icol] = c_virial->vector[2]; + snap[irow++][icol] = c_virial->vector[5]; + snap[irow++][icol] = c_virial->vector[4]; + snap[irow++][icol] = c_virial->vector[3]; + } /* ---------------------------------------------------------------------- */ @@ -355,8 +537,8 @@ int ComputeSnap::pack_reverse_comm(int n, int first, double *buf) m = 0; last = first + n; for (i = first; i < last; i++) - for (icoeff = 0; icoeff < size_peratom_cols; icoeff++) - buf[m++] = snap[i][icoeff]; + for (icoeff = 0; icoeff < size_peratom; icoeff++) + buf[m++] = snap_peratom[i][icoeff]; return m; } @@ -369,8 +551,8 @@ void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) m = 0; for (i = 0; i < n; i++) { j = list[i]; - for (icoeff = 0; icoeff < size_peratom_cols; icoeff++) - snap[j][icoeff] += buf[m++]; + for (icoeff = 0; icoeff < size_peratom; icoeff++) + snap_peratom[j][icoeff] += buf[m++]; } } @@ -381,8 +563,10 @@ void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) double ComputeSnap::memory_usage() { - double bytes = nmax*size_peratom_cols * sizeof(double); // snap - bytes += snaptr->memory_usage(); // SNA object + double bytes = size_array_rows*size_array_cols * + sizeof(double); // snap + bytes += nmax*size_peratom * sizeof(double); // snap_peratom + bytes += snaptr->memory_usage(); // SNA object return bytes; } diff --git a/src/SNAP/compute_snap.h b/src/SNAP/compute_snap.h index 9fa998981a..970c79c67e 100644 --- a/src/SNAP/compute_snap.h +++ b/src/SNAP/compute_snap.h @@ -30,23 +30,28 @@ class ComputeSnap : public Compute { ~ComputeSnap(); void init(); void init_list(int, class NeighList *); - void compute(); + void compute_array(); int pack_reverse_comm(int, int, double *); void unpack_reverse_comm(int, int *, double *); double memory_usage(); private: - int nmax; + int natoms, nmax, size_peratom; int ncoeff, nperdim, yoffset, zoffset; + int virialoffset, ndims_peratom; double **cutsq; class NeighList *list; double **snap; + double **snap_peratom; double rcutfac; double *radelem; double *wjelem; class SNA* snaptr; double cutmax; int quadraticflag; + + Compute *c_pe; + Compute *c_virial; }; } From 35181a66d09f6a40806fad810389df0124c8cc91 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:08:29 -0500 Subject: [PATCH 461/557] Update docs: bond_morse --- doc/src/Eqs/bond_morse.jpg | Bin 2509 -> 0 bytes doc/src/Eqs/bond_morse.tex | 10 ----- doc/src/bond_morse.rst | 35 ++++++++---------- doc/txt/bond_morse.txt | 73 ------------------------------------- 4 files changed, 16 insertions(+), 102 deletions(-) delete mode 100644 doc/src/Eqs/bond_morse.jpg delete mode 100644 doc/src/Eqs/bond_morse.tex delete mode 100644 doc/txt/bond_morse.txt diff --git a/doc/src/Eqs/bond_morse.jpg b/doc/src/Eqs/bond_morse.jpg deleted file mode 100644 index 6795c9e527d3a06f19f9c379c7b0bdf3e87f7168..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 2509 zcmb7=XHb)g8ihYdC>jJqq?kgevh)pAdeZ>Ljwrn)tY|_BQHtP#va*0Ah%SM^f-D%7 zl28Ps3kC>;qJV((?kc?qf&#gE_s;!!XYTXPoImHxdu9&*J%187dI; z@J9e!KnMf|gF!;yMMy|USVT-zgTw2M%$mXKcl{Fi&MTpVT z1T$8qWatermN5=TJX3pk+)_5en=Jm-Eq7os@MC=G`|N{jUvV%yh!Oi)m40-!>v&~L zG>pjyOrw`bgQY_0dnyrmjLgAHf#Qg7Hf{0uFT2xC)KJKm^Q~K1#%xAT@}~-VMaF=$ zmus`5J_?55#8~$Dx%b7812JKl8*;W3n$O|~Vu+Ebu4FHD%U6&YAl&BmZj7{pPVmrz zLZQ+cp+rZPN@1vCF&JOq;1^DWTRc4HEt4UmHmhFQ4+(Z-uiN^?S#6cd>J678Y6GVy!f3t9C!4hepiMA@Dc5dC0QK9y0avFxR~} zq&7j&S%s9O9PtHw57oIeTUz&P_Z8_Tvv+V(Lq2Hl66u;wJUTXh!eMW6Z0r5;kmG?0 z-6d7uB1p&34`$}5mHC zM=uYf(8_`3Q!!JF>K%0a5j|rI6wkX|cJ8hW0aIM;2y^Mw4kl&|ZI~}o*y(naI3M#W9T8We1l&QL}tB`OD)SJCb&staREx8QYgDRVjeE@8c{6@xU$THj;ZZKEaX4z3 zsl3jSYO~}gcX5F~>x)Ir<($y(ZqAZ~G*k>gp>`o+;~D~1o*knB{vJxcNjK6OTu{qg z1RRpRu}ZX7os_PRVn!{7k;|6|m^5E1EyAFg(mc3%!+wCr)sKC$s3!I2={1)SJ6a zH&RtiG~6lpU!Kwd%!}N>)`_v z2Ho5zu5q3(J-b@%5`B!~)oF2NufcTJ$!ksLephBShb%c*LBBWT?DeSH*N~pLIlQx1 zG7tw+?!5OzIA%r5Un^?gq+AX|W?Rac$gW1HGfro<*+v^(U+{2YMa6FY3IF1ceimJ3 zpfc5Z^X)dyFv!$&!u2OofVn!I>|(m1a-% z=VJ*Jq~*<)#@mF@D}i1*hoG2m!k>@ireRMSWZ+M=(9>In|~V4lZqRfNk^(WX1I=eJo@R;8^4h_E$HgT zhQ+DCYf5pd9hy{{p?>uW`K>>yU3F3hwWD62c3e8F8A2o3rT)F*S2JgBL92Suf^e`n zL&Td*G(OWTn2UY0%b{q^Gv>a@6bMdek!3k{Ke-qT86NF#UuhP}nA@t=M$kF9=Esd{Iw zbnrbjYrNzFKBsH;sMNwyB!l2Pmv93IA1}6pYWm~t=P5OS$ndM=6ZZaR1q6I$Gb z>&15T?M~YZ$WhB4-(G@m;kxhFeyj}~7@a0SrJp*=B=K61#;0$Z_O$W=`&O4bWx};5 zZUU1xZrD!@TyAg^qP62Srk~x8DDzNRj+J5 z58t(%B)1JIO_^Owz9z&DR0pil(8WS!5`jb_R}|r`4iT|2ph=nj)2n@-Um1Vn@qyP) z7a8I(j;@SfZFKyk)-Yr2VwZ)XO#R=Vw6%sTuQQmJS#Yu=(-mIvmp9@3>&8}0UYkK) z3HrQC%0CM=x0R*OhviZCNCD{xd13`C=KDV9qFIEzv&@4cm{=G7s1b*|#S$t5T5=0Q4*!P+xLkEK#O5lIari*htQFy>1VE!R4U z57gBEC#sk*`*P!w{Jm{=3AQpNKIO3)0R{4m3|=m;)8>rLj2~Si37;$q7!8CoO$BK4 X{tu5kbNzR*!;yvXf4csc@`wHfMERky diff --git a/doc/src/Eqs/bond_morse.tex b/doc/src/Eqs/bond_morse.tex deleted file mode 100644 index a0d7a89961..0000000000 --- a/doc/src/Eqs/bond_morse.tex +++ /dev/null @@ -1,10 +0,0 @@ -\documentclass[12pt]{article} - -\begin{document} - -$$ -% E = D \left[ 1 - \exp \left( -\alpha (r - r_0) \right) \right]^2 - E = D \left[ 1 - e^{-\alpha (r - r_0)} \right]^2 -$$ - -\end{document} \ No newline at end of file diff --git a/doc/src/bond_morse.rst b/doc/src/bond_morse.rst index 592bc527c3..26471424c5 100644 --- a/doc/src/bond_morse.rst +++ b/doc/src/bond_morse.rst @@ -1,16 +1,16 @@ -.. index:: bond\_style morse +.. index:: bond_style morse -bond\_style morse command -========================= +bond_style morse command +======================== -bond\_style morse/omp command -============================= +bond_style morse/omp command +============================ Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style morse @@ -18,7 +18,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style morse bond_coeff 5 1.0 2.0 1.2 @@ -28,20 +28,22 @@ Description The *morse* bond style uses the potential -.. image:: Eqs/bond_morse.jpg - :align: center +.. math:: -where r0 is the equilibrium bond distance, alpha is a stiffness -parameter, and D determines the depth of the potential well. + E = D \left[ 1 - e^{-\alpha (r - r_0)} \right]^2 + + +where :math:`r_0` is the equilibrium bond distance, :math:`\alpha` is a stiffness +parameter, and :math:`D` determines the depth of the potential well. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* D (energy) -* alpha (inverse distance) -* r0 (distance) +* :math:`D` (energy) +* :math:`\alpha` (inverse distance) +* :math:`r_0` (distance) ---------- @@ -83,8 +85,3 @@ Related commands :doc:`bond\_coeff `, :doc:`delete\_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_morse.txt b/doc/txt/bond_morse.txt deleted file mode 100644 index 60fd16e17a..0000000000 --- a/doc/txt/bond_morse.txt +++ /dev/null @@ -1,73 +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 - -bond_style morse command :h3 -bond_style morse/omp command :h3 - -[Syntax:] - -bond_style morse :pre - -[Examples:] - -bond_style morse -bond_coeff 5 1.0 2.0 1.2 :pre - -[Description:] - -The {morse} bond style uses the potential - -:c,image(Eqs/bond_morse.jpg) - -where r0 is the equilibrium bond distance, alpha is a stiffness -parameter, and D determines the depth of the potential well. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -D (energy) -alpha (inverse distance) -r0 (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From 48485f1e2f909ab0bc7a5be7f7a8fc9c0af3d238 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:14:15 -0500 Subject: [PATCH 462/557] Update docs: bond_nonlinear --- doc/src/Eqs/bond_nonlinear.jpg | Bin 3593 -> 0 bytes doc/src/Eqs/bond_nonlinear.tex | 9 ---- doc/src/bond_nonlinear.rst | 33 +++++++------- doc/txt/bond_nonlinear.txt | 78 --------------------------------- 4 files changed, 15 insertions(+), 105 deletions(-) delete mode 100644 doc/src/Eqs/bond_nonlinear.jpg delete mode 100644 doc/src/Eqs/bond_nonlinear.tex delete mode 100644 doc/txt/bond_nonlinear.txt diff --git a/doc/src/Eqs/bond_nonlinear.jpg b/doc/src/Eqs/bond_nonlinear.jpg deleted file mode 100644 index 0f18d8e73fdd11acfd0996f0bf472b6b3757809e..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3593 zcmd5;X*8Q_*M3M)QA2_nVoD_?rW#sBOH7A|qX^PUs;#Mn3ZXT0I%;-~Iw=tyVyFr+ zR*4vj(yE$@8Y?lhhN_}%T0MHGdiA_(ec$)v`|k1CW5vLPAhrrxQ>CgaBdC&m8|_BBCI$ zn6S{E-BTMGKnMg928n`&Ma9H_MhFRmz<>x;6efl+l9jh1FvjHeyZi1j-ls{8jJ|oq z_JrSc&Zq*?H$;15P0v8-HnN-n4JB31nEKa5z!V zN~v@ufc-kqNvSvfsORq06VK&jlJ#xuk+A6E>>ohX;e<&GR4>TnHI`z3VrU;f%^V_+ zZxQSt4CT7EnJYX01wTL5Q9uoJDKlc)wPq&=Pe1lk=y6n1)DpoQ_96doDW}ygmMD=1 z%~I}!p`3}M!g!jolU5=7DyF=$VS`Ilxs76(`cT~BH~lR#t~WJ|#`EJB{6jJwjc7U& zDN-A2Pu*97}4!OI*L?koO{0o=Fuv4ucJe~X7mQyYh{Kr z!XVu@-74MzlBr9bgeekkH6z)y6hH9Eh$n|+Yn3g|6(`-0DDfmbLM;N1m|{u65Gd9)rNQ5>>c6`Efeo#(T)kZkq2j} zL0x56j!!5<1P9&}EluA(Hwht7BK&KMwqLC4nfVoh=R+6(u`WlY_#!?v?Ef$tCEdwU zIuRyDsXO5OGAstZ-KM|zSA1Ut1CK&4o&Ng5|i1WRpF%q>*YyBfe zP#O^zr+S@nckzps`GBEOW?V&tWKF)};qVwlcdjneafB(uIet}Vd8EYg)$i$Vz$YiH zkOEo!p{IUG^3C-r@Y(|3kf&Piu|2#}p}u~#qO7LRebR34pa&gk)xROYVGg45s+?SrACq0LUM-69YBG>a?w@U!p4w;M%|B~qIOi#(*CpBF|bt}#ruQ2{tnN>+f98L1REbN1O_(D4Z zp(|GMV+aPJNoMX^nY>o2BPqEC#^DMHc5`9>tpD9VD3?t z?{isZpq>Htd~|u(u6{rsX3;#0#H>AC)5|}~tUuknPJk!3c9EJ+QmUr>Qt5bpqb;9W zuPuz1OI7FxCCGM9yf|FSvK?#K_Kks#SS)nLmig(>-+TY5qE}2oJK^c2r?kY?$5aH_ zD-J{!ymgk~qePOeUM#uo+fTV6NvnQVw>?*?O0{cm_86qNl>8%hjnC)89)cgW# zxC4&8s8w*h-u=U^-zFJ#JHQLa9l(bm2^CMPoAn?%YzOLuitv;EDzN?gPdXTTA#t85 zl@~H-X`Cx+tI^U28y!xRYI%8)b5LD}9$%b;RDscov&;i7mghzbTnC6I!&z6Kk$JBDpv(R4f2B|}NBkm3Cw_Qz5(Lu3(_;6VnuJ8_ELE^nz z9lnBRO4r90Jhennqjht!4M%UKZ6Xb)w)%VY?{#XUbzaSvJ9U8A6*tg0FHj1j;>>b% zQ%lTwtIr?5)(P?wE>i~I_~qRdJfg(Sn^m3GJY&#om#%F3PV3l(>Cb+Z6J{S&--Xzv z_n&aj4@Qx-35MA%Fq465FFCo)eNO75CluLVUz#3!{J-Rh`K~jny$47dCHh}DQJ0UVw@Q^K0JRM)u|n* zhDt-GvqcG>0q-7?N@JndraqciNO(m{+-cHUj;dnvdTDOw=>N*wxDR!TP^Pnupo0 z{vVmZbXM#D=zSGesN@eCqT&MjxtIzF^PX!38okf(rQ1i)ALFGLW`ZrnsL=TTH~xt@0~T$_il(H3S*bp{Y`nE zX*_Id85KS!$EOFzSk7%70E_xpa`{I0xoOE=ws8n&{ewDKaJ-P9dIXv>_w1Z5!iMX{ z7?LZxA8%;vYO>`*Fp&L5OaE9j%R0nNOQ+hTo*AuGrUno8dR`Z?L1q@BPj2SdC$=<} zE=()EZ?c*_fm{ln0?ghDy`Xl!nw!Qz^@-!Z-r|z>rca=RIJlb@*i~Mv^gvRPIT}|B z;H+{?Uj;dYkQAgiG(C9l2L&=7g~m(hv&i_rlC`5e{zOU@0@V(cDwxp+vp$dcTCDs} zHPiCpG%g;WntG1UjzDI4&@E^VuKhW&eub66^d-e_e<)9*jC>+rkUhf7+Ft5o-EQSQ zGl$pEIk-q;V3|4YBYW?wSLPy=pZ~~Z04~*pc(ulJSB=c~2yxgrCEfirL=SHEoXZocd7D!8_JYl-v;c(aErDIsv~lDJ9&4O(3bFWyj216MtESoPAcr#R=n?G zagp&fVewuiQf6kACWY-;B3R&alq&QdUOd2PUS4j3R!8Kg2tc=-)3lLSKZRgYkDzlU z^_A|{;0_W#A$;IsM*~a&d}`)chFSJpPVu+#t0Jtm=7U)N`ZHFff)oVe)+7PB_=F{o z4%GlWJ&T-n_iu9?zHs%*)%ekVLd?O{|ghS%=;hGSxD89S{oKg;gRX zc1uUxqw!crY~qMKwLI|tX84%;)9COoM{rHU|BU1uINbG>-%LSkS1sveGgk3hDAg@@ zdO@uJHT+Lxag-Hk8SlAE72#0LlK=ypci2HQ`aKHxMlUWBFaF+os#1DyK~=y{E+6*z zrt6{8^|)W074a%qyw{dZC7sQ;DyW$(?#&LWC4~+4qm57fAuoyEX8m%s*IK88m^SG0 Q{Cx=SpF;ivc)T` of equilibrium -length r0 and maximum extension lamda. +length :math:`r_0` and maximum extension lamda. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* epsilon (energy) -* r0 (distance) -* lamda (distance) +* :math:`\epsilon` (energy) +* :math:`r_0` (distance) +* :math:`\lambda` (distance) ---------- @@ -93,8 +95,3 @@ Related commands **(Rector)** Rector, Van Swol, Henderson, Molecular Physics, 82, 1009 (1994). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_nonlinear.txt b/doc/txt/bond_nonlinear.txt deleted file mode 100644 index af51383213..0000000000 --- a/doc/txt/bond_nonlinear.txt +++ /dev/null @@ -1,78 +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 - -bond_style nonlinear command :h3 -bond_style nonlinear/omp command :h3 - -[Syntax:] - -bond_style nonlinear :pre - -[Examples:] - -bond_style nonlinear -bond_coeff 2 100.0 1.1 1.4 :pre - -[Description:] - -The {nonlinear} bond style uses the potential - -:c,image(Eqs/bond_nonlinear.jpg) - -to define an anharmonic spring "(Rector)"_#Rector of equilibrium -length r0 and maximum extension lamda. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -epsilon (energy) -r0 (distance) -lamda (distance) :ul - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none - -:line - -:link(Rector) -[(Rector)] Rector, Van Swol, Henderson, Molecular Physics, 82, 1009 (1994). From 2150415888804891c3843536b584758cf680bbcf Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:18:22 -0500 Subject: [PATCH 463/557] Update docs: bond_oxdna --- doc/src/Eqs/bond_oxdna_fene.jpg | Bin 3866 -> 0 bytes doc/src/Eqs/bond_oxdna_fene.tex | 10 ---- doc/src/bond_oxdna.rst | 35 ++++++----- doc/txt/bond_oxdna.txt | 99 -------------------------------- 4 files changed, 16 insertions(+), 128 deletions(-) delete mode 100644 doc/src/Eqs/bond_oxdna_fene.jpg delete mode 100644 doc/src/Eqs/bond_oxdna_fene.tex delete mode 100644 doc/txt/bond_oxdna.txt diff --git a/doc/src/Eqs/bond_oxdna_fene.jpg b/doc/src/Eqs/bond_oxdna_fene.jpg deleted file mode 100644 index 3d1157a29a33708fbd54df8ed86b853fb76bc62b..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 3866 zcmbW3c|6o#+sDrs%*f7+7$e(c3uQtm3>r&P4cWKsTlT$CvL;d?{K&p1OhUGhY(Mo& zwrqn?*=1i6=AM4{{XEb8yPx}y`+3gyb)E0)yuR1#e6RO)&UMa*GD4XGY?m~3Gywzx z0EGGg3K?hsI6Xa#o(>L!!5A3e$CwbzOpJ_7JRF>?2tE}52|g4WEr5|06%djXMx({f ziA$c5k(HI@7gbbNz+R9(D~tU#350=xfr*ico0*v#D~J}v{+}D=4Pb`@RfrH2A_QpI zAy9S*r5*572oy>~3#Fr@rKNh`rhW&s>~tK0 zGHUdk1RI!;Hv$`$kP8=9uWUu?_pM>h+WLeu9OF99&4W5AA}S^>AuA_;PC-#g<04*D zOIzoX!F59;V-r&|J9`I5CubK|UqAnVz@Xq;5s^{R_hRnHCMG>ePD%YOEj=&4ps=X8 z5d+@;{>H~pO97n)`&zW-q95G=n3XycYVb`pM)D7k6YeTsRuT-Wics!VTSc_RrDT`{K{oA!4RY^4)KE zwUwyM)KdVbt1E^h9Vi&_n@) zKAj_x?zyC-@y+pGy8TlT{iKkqq|u;A6W4@`L$@M_(nB^c7XKk$EtA9;o?8p4rt$vR z5)c+H=EG>0NDq+()kY^j#>vL%rb*2bD={|>!$*4BgnJ_ej*$EZBI%+BTTK+u>fc2H z>^R;neduHOs)em<`tp&o9-F1)HI=O4RAF1L+CLiYt}FcPQ0rM~3&#V$hE9@u-bmcj zyWg!YMsw$b*Dn>vN^%}!b-v@!Np~e)n~gp)uI=Au^n5u!p}Ap>OuD68%bTh|dxjQm zSLAhtMd35MNI6UHl)0tjB5xYmA}}y2;28uX6MhDZ6V714I|uD(-fOplrC={+lLfI# zE6y3`7I1to(nZp8IRujtX9aBPpcx#>EUaH$wj*ZT7>jBx%`aIj4uRJaEGoU3W?VZr z6t->@*SNSS6;{*~n7Iacm`yGU3UQplDaR~psVn1wZBVqh%{}8mIX-oBBD_3xIl4bs zI04hy%C<^V&eB*G ziEbjg(aD9bVOC6Z;POxVIjqwMLWY;ZmkfWo`XcgGmm)HG!jkuS%oiHdcPpFxjdr3S zV?F8N6UY}8{san`M)fxbP{1PvA_cqx;Ba&R#q(73GDk*;*rI5`ul}?{_PH6m6umvUt3j6jC(c{j`&uP{I>K^XUfR);N%@X zYEF()DIkoRw|L+-#L|?j8(KQw(3Bgul778kNlRQ1qr;Y8fy1EL)LOsVwH#mGZW1N@ z)@D~~YI*6nx3)C<2&)BjAiV{LT(MfjJ2r%i1^+O_NPDloY2D%3A5`io7}HGhzVpgp z63*6$hv3M#ZegO>6mgbh6d0rW)$CK~Qjg~$=%r1UFXpPrGjV;9Uts)deOyT8oJ2!3 z_|hU5@OpfyAvIcsVP0t{L(0NzA;r<8LdZ$FtdjK3Fd9CQ<(oe5uN-L5S0e?t(sCVY zD4ZJ^Q|OC)d|p^7lN@8S!4|~lyMp6W_8BuictYX~9gfbXfLx1Vga3W}JTKpSq_ehN zkc!HjQLpUme*&tK`Lqe$$Xrh)3o`yfu*|!#Vc|+1ZQN-KIo3FrT5P(NU&XTyV~zsavH>Dqd<9Upw+e7Opkc@=rXR4*8IC3&vq= zXK`7ydygE5TB}vzk2N|`meeq}VT0qVp_@*h~2Uj&|fAby%;1Gnr4zIx+W_T?< z4fevOf3{99Ey%_T7AI#q)*fz^HC~ItMuc^Dx6T#1EvA!VoF14h+(9*k6QfPicV>w< zQs%EPPCGc-<|H0Rr!R`-z{|^Ls%oOg=*S2$Vf@y$GZIDlMe;d)$%CHd^3aa5ut29_ zfuSe_B#HvygV|eW+^lyGRrg|Bid{Ywm&Fe6rV@WwtoQ1;^BWC`fMfQf7EkHRtkO1t zLDkV6>&*pE3b@m?XBaC+BUbJ{<=&@;xT%Safs`q`sjtP2%Noxc{DCPlHW_38tW&EN`F_EAL;tlN1z4d%kD`1n_5P(sdm-yI%vyxC=;DHfbi!Kc(PdBmf+DT~Cxm0r2KZLFAe9gY$_Nv11r%uf}anZ|KYWY`!CyY#;M~ zXKAt*r+2@wc|eyz;A)fa&5=#v6XkEI_jPqnU^)5J``ha8c;D+7nTTAQUm6e1`lPId zV0*)@!J)|$_W}=lMQy(ixz-<|Q4nO_zSiZ- zKjLp#*I$5l?&ih({!!xAPbT9^0v;f!W)qZ3Xoww^Z4!%kZXJP!m4w}r{c!XSnjIi< z{?j4NUeKj^&}7IEDNA9Sb- zXsk-wd&SB+(cvlmG}O;tZ@T<-8H;x7` to model the connectivity of the @@ -47,9 +49,9 @@ in the data file or restart files read by the :doc:`read\_data ` or :doc:`read\_restart ` commands: -* epsilon (energy) -* Delta (distance) -* r0 (distance) +* :math:`\epsilon` (energy) +* :math:`\Delta` (distance) +* :math:`r_0` (distance) .. note:: @@ -121,8 +123,3 @@ J. Chem. Phys. 134, 085101 (2011). **(Snodin)** B.E. Snodin, F. Randisi, M. Mosayebi, et al., J. Chem. Phys. 142, 234901 (2015). - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_oxdna.txt b/doc/txt/bond_oxdna.txt deleted file mode 100644 index 88afe435e6..0000000000 --- a/doc/txt/bond_oxdna.txt +++ /dev/null @@ -1,99 +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 - -bond_style oxdna/fene command :h3 -bond_style oxdna2/fene command :h3 - -[Syntax:] - -bond_style oxdna/fene :pre -bond_style oxdna2/fene :pre - -[Examples:] - -bond_style oxdna/fene -bond_coeff * 2.0 0.25 0.7525 :pre - -bond_style oxdna2/fene -bond_coeff * 2.0 0.25 0.7564 :pre - -[Description:] - -The {oxdna/fene} and {oxdna2/fene} bond styles use the potential - -:c,image(Eqs/bond_oxdna_fene.jpg) - -to define a modified finite extensible nonlinear elastic (FENE) -potential "(Ouldridge)"_#oxdna_fene to model the connectivity of the -phosphate backbone in the oxDNA force field for coarse-grained -modelling of DNA. - -The following coefficients must be defined for the bond type via the -"bond_coeff"_bond_coeff.html command as given in the above example, or -in the data file or restart files read by the -"read_data"_read_data.html or "read_restart"_read_restart.html -commands: - -epsilon (energy) -Delta (distance) -r0 (distance) :ul - -NOTE: The oxDNA bond style has to be used together with the -corresponding oxDNA pair styles for excluded volume interaction -{oxdna/excv}, stacking {oxdna/stk}, cross-stacking {oxdna/xstk} and -coaxial stacking interaction {oxdna/coaxstk} as well as -hydrogen-bonding interaction {oxdna/hbond} (see also documentation of -"pair_style oxdna/excv"_pair_oxdna.html). For the oxDNA2 -"(Snodin)"_#oxdna2 bond style the analogous pair styles and an -additional Debye-Hueckel pair style {oxdna2/dh} have to be defined. -The coefficients in the above example have to be kept fixed and cannot -be changed without reparameterizing the entire model. - -Example input and data files for DNA duplexes can be found in -examples/USER/cgdna/examples/oxDNA/ and /oxDNA2/. A simple python -setup tool which creates single straight or helical DNA strands, DNA -duplexes or arrays of DNA duplexes can be found in -examples/USER/cgdna/util/. - -Please cite "(Henrich)"_#Henrich2 and the relevant oxDNA articles in -any publication that uses this implementation. The article contains -more information on the model, the structure of the input file, the -setup tool and the performance of the LAMMPS-implementation of oxDNA. -The preprint version of the article can be found -"here"_PDF/USER-CGDNA.pdf. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the -USER-CGDNA package and the MOLECULE and ASPHERE package. See the -"Build package"_Build_package.html doc page for more info. - -[Related commands:] - -"pair_style oxdna/excv"_pair_oxdna.html, "pair_style -oxdna2/excv"_pair_oxdna2.html, "fix -nve/dotc/langevin"_fix_nve_dotc_langevin.html, -"bond_coeff"_bond_coeff.html - -[Default:] none - -:line - -:link(Henrich2) -[(Henrich)] O. Henrich, Y. A. Gutierrez-Fosado, T. Curk, -T. E. Ouldridge, Eur. Phys. J. E 41, 57 (2018). - -:link(oxdna_fene) -[(Ouldridge)] T.E. Ouldridge, A.A. Louis, J.P.K. Doye, -J. Chem. Phys. 134, 085101 (2011). - -:link(oxdna2) -[(Snodin)] B.E. Snodin, F. Randisi, M. Mosayebi, et al., -J. Chem. Phys. 142, 234901 (2015). From d13ec0d09871c794b634970e4d38ca2a44fa985c Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:27:08 -0500 Subject: [PATCH 464/557] Update docs: bond_quartic --- doc/src/Eqs/bond_quartic.jpg | Bin 9554 -> 0 bytes doc/src/Eqs/bond_quartic.tex | 11 ---- doc/src/bond_quartic.rst | 64 ++++++++++---------- doc/txt/bond_quartic.txt | 112 ----------------------------------- 4 files changed, 34 insertions(+), 153 deletions(-) delete mode 100644 doc/src/Eqs/bond_quartic.jpg delete mode 100644 doc/src/Eqs/bond_quartic.tex delete mode 100644 doc/txt/bond_quartic.txt diff --git a/doc/src/Eqs/bond_quartic.jpg b/doc/src/Eqs/bond_quartic.jpg deleted file mode 100644 index 9d092883b2ee55c75d9222a41836ed259ec6cc41..0000000000000000000000000000000000000000 GIT binary patch literal 0 HcmV?d00001 literal 9554 zcmd6NcTkhT+imD5B}9}O2vw9Oy%!NBAP82P6oJrtks7*mLhsTP6_F;rgeEN@9fZ(3 zgc1UT4goH|`R2~t@4q{D=H9tyXLfdG-`U-F-e=Bxp7ZSWFZk8n>B_^W0nSDkF zAi5cn5R;ISQ<9KV0B)YX8Iys?DeiF6i{4dvMR||QOicQT>&IXQM()>oZmFZ@RW;(O zAz!{$@V?beN*i0co(53+pKCyr^IMB_1hurv1jSWM-{Qg%q?UX^;d&JbQ7WU71pDif{ex z9}b%2e8$_1{IG{zo?$P{Q^o|_MkXpv_P8un<7bM8dtdq12b=$UbvW4 za3x0O6abVLC;+2>E5^~5s%(K%mrXaSysfVRwDKf@-wDLo78SQDv+gdh@|&nQlF zXIAb=ehR(JenA^6yLv~nhee3+COalvZ*{lGT_AN;fBO~M!R=Y((EB2wSHnL2G}u!e z$L%}1cX<0~Ht(5?rz)>o*G!to(Q0m26m`;be4A!A=8lH)>vGD-|2@PgZ|Q6cd|&9s z1&-o`h^%J^`Uq)s~=w1blt79I+Oy4ACH z+5+PB&I$^&uhr;zNz=Wzv*C~Rq2=m`C z)d1F=$*n0O#DBr5gN+TFefHo!9h%0~(GDA%F4a2S8yYp$ zCsonlIuuuP+tD+}?q34=@f5VQ^VoLad4kocaf zjrU#*C@$u<;Ex!C`PR?qg`jE$lD4mc**n&E9@3+;ECP5v=-d4vO!7hM$3

    r52}9@ z0t=GWc^u>^D(h({_#=%th>!5aJGL62!7HR@%6H5{In`G%-$3L^L`ppgwx0>WSRR5r zRD+V}M4ZcyQqZz&0dSP5w)Da}Kazl_Fi=Nw-hoEih#84dQ0^&Ui^v61^amlR?Yl~oDSkZH{lBXL zMYp!gTa^F4+3T~Cj;*XeH_Ly`61Y3%{AjM%mn_&fFbk&>^uP5$Y&rq>W=Ag7LD4-$ zF2!I(2VU3&Av0Q0mOz=)OF0+MRhWo0hyL>g;qq<*Fzoz>Qo`zj007;10%ERA+`wR9 zxGwsEVN&*ER}q&BZcO<{grF|^oz74O{|hFFx_c>?CrAqQmwoqg$pPfW$hQLN#hvM@ zz7Ri6JE7gKX3ycPrMo15w?eo?(}L?f6}-$|KrGGQV(;hqe|I5uVdN~mI*S7l;4c`v zzN4RIz-IXbf5sBmcKkeQ0|5LmUB7B-Kg1aR*4FiBA1*Qf>Yn6M?KcRC?kj*G!%26$ zRPc|lA^s@zm-4_n4_mYQJcDn6OGPnH(&x*!aUTMpO_y#u z*q+!wahz`7%H%?H0l*C!)~Ff}6~-|}$Qk#LSk9^)9n^jbr1KQx)u5l@CTg7Cpp0HD z#3#GepK$Y?ag9N_taU^|+`aqn*J<7Bh72BPgz{UY&tW@M7O}m#>crpPM?#9vW8C-( zAdJeGUlsu_81KACBh)RL_@b*Zx~ZO@CJ6w$W164%lyh5xIRY35qOpm4%GWplr9vuL zI%)UNN2z~Z&4Ha&Z)09{>A*Yk9;IMJug-|$SHRxX$h-M1;AV(XwkP59F7;}h7v8k^ z`}-jt~GM9T^=Jwt5BX%{{rCzuAngGD5(IL@ztcS^$# za_z2zsDC}QH@iH0tvgYiK7TCwK&``z z8h}jX96nz>V3;fL2>yM&+A5A!6-n{*qx^a8sD+)^s*IZMB10CdbCcYC#xt5m<&FXY zgD32agS1Q9d6DIU^5R*BrN_#@|$V0SrP8G~0l?|a{5W=SG#NEn1z4jv;(;L?2WE#?npz>fItvZw+ms*o z?*H*j>Ei94rkIu8FZ{<7+o=l{kjxqP<`)16t^M(GJ1YZ7#ZeTy)ZB+&ozs0QOig>d z-t1@*ig$+(QfROp(i}}JrRm-RGfW4_q5Aw#RUal--V^xGZ0gSk?Px-CDH0vd=WkMc zO0jFO#m1> zk=Wd?1_%&4Jst}|LU#6??M_j}yPUbdFUrM98#Vfz{&hIW{Ycn6PnRyLmCjd%%CEHq zUL8sP(T$7m^$-DP1-=q~7XSpE_0l2CgZA;KVDSZqUVCG8#h#Gky3JC? z)48?%BjDKt{o|mZrb@xA%)Q)DNp-a@@<1AgyEms#hE*N6GD0-QiQ4)tNAYC*feX5i zWDWEcst1a(6^w$vG7G|;50_x`oVw!5RHHfVfID>yhasgfz};X?E<&KjD@fb+>#}VX zvVuIX;z44+0_K~y#I0bfZqs(gweCJV01$rw-YDY6?0L_-96yLouPtC~gW=2dc`NjJ z{IdE!Cg0HxJDYD*$RVM6R$7z)eY>{f2S^>0O3qbrf&dH3{mge?wr=nSn9x8Kqo!ubtfTX5hy3|)OP>z{#dk#CEt%l9 z&AI@#X7p^cq9}$pKa|wL{g&Ja4(KV#$sJ}nB%s5 zy~@glt(3FJ{qZY6C9`CWt8;#Se0qI-Jz#Th>xK>7iB4XeCZcAeG2h0YwEZ7Tb9zof zBB8(P;&2-mw6OovB`3J+Lf65YV>LX2qqwRO*=@wIPq!Z1YFI3^8I`?GN@z~*Zqb$3 zJK0MbS6h4BINoyG(F=I($p1&ff0{pS)?frIr5$v_3)~>iKb{bU^UNQw1tDi45BSY) z*~vSC&2GeEBkP_nq3El|s%lz!cd)Il#YvX`=D~Eu@hgV9#(q6FN=>wB9-N-l|;ZUH;;cK3^(mEh8W>=5yub{&!J#ozux5>1v z_svLHW}^!l&f1QnkNO9{1O~&T?K$0efM?v88l(q#@pDV}`l#KZE{s(;&3?0WRAt<0 zhi-x|t$s@8wV2qxV{`T9?0yt?G|p_ASDI*u(IRM^0creg;Ix)tOK+pStrT}3wkDjo z5d5(vfo<-ud4&}XqOuP&6g^Jfb)xbwS2r!0!sZ`0cexPyJLy^17kCNlg$`~ClK*bU z4oP{4Ww7M$RH>ww5qmg)m!HT2xX66NiGL6H`&j<30P}l0QSHQ|g|y)BFwnK?pX#IK z@QDk8bp0LRVnK5*`~5LI&U&%ZvJ;bbZEj_|da-ivQKl?*>TX1EyTwz1dqGmk5cA73 z=#T2jviC;wcK?p`OPSNj1co)QRrJK=0{MMgVG_+PV(T-}EudbmTyNg4;@Bb0{)aY! zhR%wAgn3Pc=)>0OZz7=_6rrE4}r>LZfkEc1YLSXCy6fr(~qaEw3EtprF7gn7dNz2A+T2}&>sLrE!VbrcG7@L4qOxpq@JE}bfAhvDxSSwD5=thBs)mWw2=JN zrV6WTT4|Z%S(&SiAJ^Dw%{o%5*gr_y9MBuanC;{Va0HTgg&0X+m7fBav2m>WaqoZ5(xVbfYZ?z3P&00hJgqZUN}h6f92)C z6(-3U3~@FL0w6Z^f<7C#?mEfzI3eCttk=<)X-e~w+{Go>iM$#3%Pj=RwZ8$J2YLWd z4=iq%F3<<&a8ZqJV{GJjM{3S-b1=2hyx8Rt{I3)l=q!=}#PwI9jxBv%6mYkZOCR{V zs^Jn0LTj@!5ztr$tJnJjw<%zwmm7q?QNABVF7Ho+O_1n3*^aYpQlpS@=q#PN5u}Ps zJNMk6of;Wf8t*;HY0>(`di&B!Oyil)e**EfsdVCPnJI>lZ@T z%vV8@SFf_tS~P+1ykZYjCoXbOrYaX80P3NP@4`h6Of^&x1cQ7)@HPq}i=4p48Kjhe zE@l?8i*?<+pK|iu1s5(YLXhNl7hFJJgaKY7`2K>+l@G;zf5GL-#T?KD7wW(omdRWM zUn3VCOW>r4H_=R4NW1xpjjNyf?q{%LfrsaAn|DO)T$BL7dF8&&_l2mf_8O6NQAlOG=XX`HUTN=Es=J|#G*RqTsVpwao z1q3fd|J4*s2{Xcupf^z*uI)YYuqc*LKaIcIOj{DXa)`@MhQNzSMeFi^LIYqQ-Qc4j zmxO2ii3AB78%>(VpEB_i1#?3K+v78h!UB)WB@N+?rnn(HXp4DCU^cfW3P)oj~w&}fQiAaKL+6#@pM4m%By(+lTpQGQZ5)1xF6L5>pa34lws|iHB z3_t<^e|+1sj_0*F8>m@<)Sce;yhAaiM4p}R0z#ex5R{QklZ3szp%E-Uk^s7ijr7yx zz*9Ns;wv4O6;3`!`Fg z!=iy2BoI@u&l1o<0cl(g7d{)Qlj%-l98F530;MD+H!O#>VTDmja^u4iby6R2^J5{c zwjLe$hAm-H|satifgsweezSq_@w-Y(}noD3s z98=UYs6rv=`~RD+0ChnrKlK20U`41(0Ih=I51%Odmo5G$b;Q7r^>U&Bz#t&NAt7KO zAWuKq3-l8L5*h#w1BQ)>#dha9ham9N!Z+C;K0(7^B_X3=BBdm!V)l0de#jRV$P5Mr zzGF6)%I2*h8k{UohTxh~+Wi$U!1Td&0qXmoRDnp_n}#3@ubBqxI+5Zi(Ypw&caO&Zu9=xDQ*q%51?8kh>p zsb^I6)F{SyZ%Sh~s<880=onozggeFLSe2jthVZXU$!;diKVAEM2Y#gkR0{JDV%Dm^ zUA7-oml70}v9{bEPx!5h`9b(swQEhRzy2>d*Bc!#7Ko)2m^u6}Ik$+AzTfikueOG( zg;w*{E5_+JWy&1YzNaT|6$HFj72xElgR~jmh%XbB%{NpBKl^rd#Ek;L{ejO=dZ^4P zisl%BG1V^Gap1k2(6Up?-sgOYZlV-T4n8@V0|I1`ottslj&k>wG%BAB-wz;oP+toh z9fnE1V?_EYFQma-i)?@oPDd-z#T3BPtE0qlO{7sJQ~Owse_12dn5}ne>_VYXZc%e( z8l@u=Ou|99|Den)f7*>5hPv?%XQQa#{Bqm~K{F_PJza)Rer1D}jz@Iz+Y*+|aU#zb z96QhXzy#Y75|yw7(Yg&jAcmh*oYU!LgHk*uvlcf&Gi8ycvDv=+2x+ zN^ts7OF^x84XRr*1$S~9=TKuFZ7FRASCQ$QBn?IFH*ON-&Z*x-ryxVSWBz=TvH;qy zdd@~YG1N({`B);KW6N(ww7&~ln4BWR3SMa3?SWHSXWP456C6igK?ieBF z$M9*Y&?1cAEsk)WpiJ)-Xg_#?0d3KiH=`EUXOH^qP=!))1O=1O6~U`~qY|1oHe0(E zdi?&d;XA@c_tJz-=5DrHVm))lCN%0^E)m%TFolwbU-C78^&${0sI8SQF^xDqGFUaf z4@0#>bcz+0N6&xpkjey3J_6xRz!t`~SP>Opbc!+m1xHm-sxYqMcqZTU8Dh%Dc=VhA-GoDKGIyvdGw02Q(Jg zCks0r*N-=>Qrng;Y&y%Y$R15^tJp0U`cCVh_K+xOXTM5tuOyYIJZ1V^84W=YKdf)D z^sLptOR~iHU9&5(aURt>uTaQGWK+~@4+L>vV&}JDvNXv~t|iW|20<6!ESfrL*0^JW z!$9EssvfVk={0>N{Q|otid5rahT@8`Tw$AUaC*lbY!dSok@ilB^Y@q-4l##Rq$43jsrW4f-7Kz}u4cHWWKHd&R zUm&U<%r8KlFw{ZgRBWu%Rgk}r8#@(5pg^V2x)zLEPb^AzV~XJsCFjbcdnQ7pyXgiM zjEmQm7M*mC3)sTQ5YVsr5K{}|!W+L#B3(=kT?{63CeuBjF<~e(xnmyGM&RHp%MP{tn5M$)v?49^arWs4C+A0Ki0iY(vetUlkp=Op z(wm|_xF4=#JL8WCnW)~Z^D(xtAEv%7giBV>a&YU~HnN^F+lQ%=CPo;K@jUWbJM?)O zmXnNtRA^2N1AixCH*<+@oKKl%y5S)`FPe492yT#3BiESAFfLNTta#6S`fMbjOR=fd z?GoB3bc-ng!~3KEY(N=Q*vsI%vW^D|M5cDUaea>BG89jSY$!3cVMFg>MBw-`P?+Ob z>)79`M0aB}$-aM6kk$gk>9FDoE$$;WZhf+$jmTQKj(QYjbAFg zdg4BKO5`g&==#*HPK?e)I;t+d2uv~Epe*z3$X312S~WPeG8+qBaoh#9Ms=Yrx}0MX z*Alfi8mJG*Fpo_bzXCF5BF2vs9V4BS6|lGcdFbylJ2k&o(al)cFi~Z7m0gWU$&FM` zz3YZ3gT-L?cF2TeZaxV(9Q5fqJJVFZ9}!7CS(E<|dvZVNRpd)7XjTnrVIdqALOVdY z$P4}Q0=j~|-R?yeq`1duy zI>f3)Lrr&ko8ePeM3J$oY_s6LRevdf59`qIC|Ho%g3SxyKehkFK2g5J^9H*&B+@b6 z+f_zPHb|aS6M0(6%0ONC8h26HNMHwuBPTU@T~W)D`zT`YX4{gIBMwae z{A~^@|NNI67|5kBx!;Oqs$)G*_k6Qo;GTl^;ax_u1#kde#)HzSnd#Apz89n?o@N%K z4e?_2r4BYW?_npfy%i>$R~>as7L^037&28dr4$pXCp(9z4L^C0gQBV>S7CwUt-fZZe5)zmgDJt2%^wDior1VQ>?T>lkrwHs zo^2EotFF^o4V)P&$J*01vbea1jX>AuWljP=I6@5HY+6R3%UF3?Lrp%??8WtRvd&OE zyFi63y;72_F{Vt)%jEHuDQo(hvnGL zc%C7GEV8wzs;@~SJ6=^-iV~AE#ZJ2C)S@cQpmKbg050lZ9>C-`eHm5k9W5s|F~z+< zP0*V26<|v%1dmS^kli!t6FxpRKnqC}J`}1&6ct{`G?$cb!xrS`YviQtlc7gr6L?px zuww&;m{2JDDH7cKTg)8crCy5&rZwy+D{V2wVkA{khbUW?-80|j&0$ziLlqR%fsO6V ze)=lSa;B#n>FLP`g&%7$i(k-WW2kbl3VDhSuTFRZF{T3Ox?|VkdX#U++h3pZkCjG8 zB0$4&G*Xkaa2v!7*?$16wFNra)lL#O- zl4eQgIRpGW-k_-Y%rR&k2qSO5);*BM-;T>i=HNS@cpRfNw`GJ%T6?&tLuvz1S(ziz zn(6q4SWJ>3P8NWzXTL$h+?@O2s#T7ES;9^FN3Buy>vYVod6*xG5A~IB5hNnEx!sV0 zp1XEUZ1{S^=o6uWo(1b_ZJZ56RpHt2hFVCBM&`s3@o5v%X?;0LQwAvoPL7+Bb4;6je7Q&ohZ6trQWh^H=2)+L$%~4HqvEerLO1G5c^_r;+9U9 zykANpAGgw4pSE+Y3Gly0@WJewtYmcTlYNYA)3A16{}f)_vca;%iEMf~TtzVy>!xQ( zw_0KPQnc>5`S9bFTt~DzDD+Yv9;+a%?k&8cpjUzUTxO$R%D;R{0oKa3C&sr)-ffgc zi9<`Y*ifFB?>buTEmFSn_X;!!Crb9(nlAwF9wH+l@t)p8$VKIU#=Vj9AWURUnJ)bf z?Ncl+RWE{^dS9ifMp|?2kdpkCQRP`vI*a1}8-fr#D_ih;;EUydb=c>|>?Y@_NwdFt zG`&ju`r)GJ9ohG>A0}||WpEUQn3BU}9r>p#*(q+7KIF5gwwra?X$4yjg&3rR$yG*H zdqebJMzbQ+yf__Oh($tMX%2DQ_y@WqJ=)3T*Q3Wf_{ZLdQF~QGCwjeVYR-}!C0`|r zKoJy^Z$n_X!!6<1YwpXGFWXm$XXmga15L>j)S2Y7`%xbc%w z*>+Gp6yjA4^9=$r>0bf0wgTw~h*mwT_=Q3-g(nTG3hp}M%vs4446rCXt5P2OCP&k2 zDiEXDyQyigFg@zj1u_u0M$Xhu_&{^r(F^%s>{WOn`!YU%W)eur(9JgW>7}6?^5bZ^ zK7(H(`_Zm!m9A)JVWlvu6tV;9O`tv=K5&7trlQ526g*jqnzU=$>81Z%fx3y@dH#{K zSm!4a-7iMK3J}_$KekHlLX#6H+$a~3CuGCnq0oLhpDFQzBBY9 z&&WQqSVvc=&pu)VuG~7Cdj_vR5Hg>x)_IHJp#)L)$fm{XHK#pn#1|HUs^EzSi`m>} zxsjqz(yBt1Sq}FVFu}_-xV63I!Fh<98G|JB-`CT(#1YwRp8W}7hK}AUGfJxxLBWE& zu`7{~3DeX*dau~PI+q~19ozN}zAoepN=n}mA$g^cUe$$|Lir3w$o>|x^{}3o^N7W& z+*d%Z!e^a;FbuaTh2|=cS*-yi4{g+^@NPr;c7DuHT0Ls>A1T6$rX_b_qu0_Yn&G9M znD6E7-F~Ds#yzM`-*b;lb%i>;IILq(v%h4?)@(iujeDUR8 zmOyKB;U_OdbzOW}T$3An3_G>wE%l~;-94~ZmcHAU^EkLwowZyzJfl~EenUmL6R$`r z$Pn199D->qm?|s@jINum5j_M?EMQ*Uk=5C07C1Gr4S&C4Ve#%ZirX zPTTz@_Dof0c@H|FrcF8B%BsU^do{^*!Tvsqfz;d3RmG$xw1nd3*SMes<_;RJm!-p)&+< zAGcsu&~NOiwOlQAV(-j((oi`*s8c7*6jqJM={Ck}$8@ZF9kv45t3^Yci7!Z=&+>ZqLWns@s(m=}>54uI?_augdttaz^qBX7Qtu5OT9* zVf($gZ@VvN{ZFQ0ACYaFw`A#yWvvHqSp^1)%aRcXhTWFmoD|JEKHfRs^^DvNCko^? zBMGjff1-Dnr3V?N;ARAX4z3$PFQgwCwuEUr+24>cr%H@ILr%_^(4;9aBiWKRc~$*% zOXPcQ%>=Kp8O_qlMvS<$Z=!LdW-|eSOo8l&alpYzJ~D391?R~jwAj|oLjv)M^)(8#-CORA+yM>Bi7X8E`1_5! zi>NZK2{sH6nJ--YpyP@}SMPBQ%~*O``bjfa`8ETLIBsl8JMke95*iCq_vXYFoBPaW z&>A*7wx1TEL*pypC8IhUZm4yyq!Rt!CcTcWN%uw!7UTtB+_;LpTXW zO3waXzy-5Y?BO_C8HH#j*oWS)^@AxBP1@vm(ImTwy_jkdg=y6|F+ibDz@=EL1HCaExc20^ zEVCiUU6nUa6+cZOZD$1MaK4$letQN=eTtNt0zJACQeu_vyxDDrYcq~><{MOhl$hQs z;BbZJKx)V<=%;^*hPE4{EiSE~Jp1u+e?au8upSF3lkunQA)d@u#0T7Fu#V=iX@2UC z-qaP_msOML&!}1B{qbLVSS^>K8Ue5H!sVkJsR!RYKyhk8%EWM zN%AEZH&H2!A|6K#A)_JQOQ5Z3>A#`KW;zl=V`9^j+Y} z?gTpUO-Ve$!`VRJ(Hhs1G=H$^LbpW+zv~h2t?DfuUg~l*w;0H73ik88^^l;0^ARR$ z%TqvU{X+~S2at252lxxn8qg=}DUPya3C~+h(-R8xK~e_??oRiFWww8`in`qU0h3{b3_1mDjAg zvsLIR3KkKY=DdrSTHGI&nC;{QDkkYTlcJ< zv8nHtAoEfPh=hI+SuVDuG3vp2N46&49O7DNo$qjx-#ik7?WTZIq|qYtw?Ntv_W?OU zplgyVmv{XfD^h{DTb`1pVdOKaxBM!Gc(59pqBjqNtyR9?m@J5W@pFk;DJXN8YZQx8{XHW|Z=e89x7 zR0=GqQNKZkZb@u^m(45XDXUbZg6;J{yA0EU#n+Jrrmy9SAY(->s<+aQay%1J$h-T; z=(76Wiwt@o>vi{qQSsSjN8$1i?UNeoH!BKx5oTwRXDch_5r4$+Posthy0*iG;1$4x zx}=tcd>0tt&WOac;VjPh7Us^lll7kYe#Tj_+bNa$-p56Oe9=`EE=b5=+mi@>!I6P# z^1H?znjsNs~^yw|5nkZMiEXUrQMwy_dvIuHk?8> zoxHBRpg+VeEWPzMn-O9I-Kqh6Gs3DZLLDQUHF8EclumV`%l;FD<3sZe0_JW}(rsWU z{%-KeYwTXW)98KL^_?n(!!OE73w{cDQLz`1``ZHo>|%sQ6c3Z7<fa1WZUc5 z-VQjm)HbkeB?n;>R{I!xQAY&sV{U-6PB{g$?^pwtjm1uuV)(lZBwn=&S5rBq(de8~ zt_RvlkxF9(ITc*0&n(`3o;8_l`B)oL>_%&b^n2*1-f&fBdR*)=<$q89Cu>n!J;v)l zVgHV6A8Ui>v4U)!{z>t!IFgm$U0(Rus|8u)ckAYg@GmQPAgF)sUve%@xh`u4y%9R_ z_P^wu0#0Gny}wuM=gp^NWv-~0iuSCfWtm&{$Ju#&_VTG`0-K3#EEt|~YuK2u|4`Qz z?q;D)O02+#)6mo?$~2FnSREzo;bbb{sevY7mY%ff@WjF~FZW@J(Rzu$b~XS(TNRVvADi zpe|b<2d!2;SoVy*DqM3+^QTDcc7goIIn8Whi1shv)fys4L-E%O5z;bZl{jb;f=iNX zGQTPq$WOG30Q;Cquj?E83g?TsRCdeqL_KL@WTCe{U!IvoUbUHr%joB<27MG0uc|xE zb-o=>S|T}ai9%2{m#Pk8p3E6#kEbmh&IzG7>qASZ;*IBZB%nHVcOR4aFgsc61Bd0U0gmk-iks{r_*<>=? zfZ24hhjc~6NUL*4^NDZ4o=XiFz2_r))0Zbs^U-?nQ__^^WMmKJ{SguuZwR?|3GkGNXSfhuMnwTO&vY9Uw z&(pO#y%UYUcEo8sE8v0hp~cARL9z;gqR#7Wh@1r&)h?vMwuz#gSqRk@=;B~RGitoC zJ8Tv4Mz(?jo6rA;{$HK^euF4#n<)I&q>AGSnOYNwD|Sk)b8|^b`a66dsi1cFJPNnY z&6xroxBb?Pe|l2S_&~-^Ov3%feT=f3`nh+NCHq``Qco-oq7!smgrU9ygksZ(t@G{* z6fC#fg`F+I>_UvoZ5%Hy5tK8$(_FI1`-64b=;ohOw!Z>K9lNp8i_1%w)2hT*1NFl! z)gebyOv+TuESnFU15RTjM=9r#jTsB*aJbZhiB83RuJa8NGX*mOg*dvuPVhcjTY~=1 zHVcP!Ja6hoROlMIjhh#V%$jdJ1c85`vIw$$fO{)Zean&e>G{3+E!>tUC%L42x95Z> z_`nEH@2$e}+W{0U^kO+>Zka4WBVnqI0du!fXRye>w6{({779bqS&_$ik%U*UKE@L3 zl7FuwPbP)jpui(hSf)WVf`9#?`U4J9eek?y5!S2%Bk9Ud6qcSLaSFUGcO)VSi<`*1 zOo&6VNwrdFD^1Dv0%x;!3ud#F`*JqRo#ax?8wFd=HhgF-v{>LlE!FFH43u7VZFE{d zO<@}O%`o#3iOoETe9@j0L^jo&mWKpSAgrp^xNUG?Axcq3Hxbwu?NTO3IZ~;I*P^#U zikPt`tkvAV&sBu{G)aZds*@1^Zeh-Y`yFYc_X$Ha@63zFFlF3%+X-*s;PHSDmlVZ` zcJD?@+I6&N-qZ{Q^{Wl^`Up~mj`cWzwpA5KcoS75L=%}2TGWu&%zew4JyN%*paKJ8 zFg|o^I{+irXO6=NP-x?uE;D6qK+HDyDoUvmP)x;1Tl>IyXzwHs(0kTU2Y}UWWaLBk zFmnv&j2Ns~EmBHyM!|@27OnOKs0Kh&=aw1Ryv&{{J>C~SsG_XMvEaH#gMUIQ$6Br^ zV8)=4?Co*$jiN*Mqp5EBH^WIUKZ-rd&q~o(^+wNP3c7*C#Y9K*?3o(_ox59sABh#e z4&uaK8xfzN{nIs!Cd*q^J)d~VameL8-NPGRqqWIeOV$Oy6SPM28OA}M;=Y#s$~7F) zlXvMe3t2y+3klxf%tdfu%5%t5ui&FnW^tQbp#m5EBg$KK8~xr7V2PH=n#0AR5XI&F zaBz&gkm>qftaTYlOF>cGZ>v=i(IxZZ$sl)?Tvjnx*EI`j^8Lu++X|1t5{x3N94tIV zEBH+2|FQO#!ErQ8m#}QfVrFJ$W@cu|Vrj(8j21JGm>Df*w3wOMVrH~t$vb}TeZScI zMeLv58!-_x-4WeYla*bSbNJ3X7E^64AfPX9^}w?#&a74s77W8zPBgPik<9E&jAg z6;EEO89kUWl;ycB!bP(K@wqT2oC7!QFV+2b-+E0Wei~w)GI7YLjHx3s-(qOp;@Qv@ zsGBWbe@}c#7>F-|LmX;kF_chOzUQ3Sk57{bu_k-4oT+ZCHkqa=L4Jw8Z!g2zx;v4* z$PY+WTD2)`*ZhjzBPFx@dH=C=-*&&`=aWi8eJ+Rt4c1w zyf9dngK=eug5`%uA8FV6uTIK~xoi<_RFlZ~@@Al@BfCwgvyB3cUT$eKI(NbC66gG4 zsV}b9Q9JT}WqPnGAHhiKmMQn7Na9H3{w}7f^3Tx)k?+_(Sdt^u0mu6?Z17PqXRI-W zbC_)njFn$K|KdnOkx8!K(~H;BB%JoC&vKqYNMo)C1DELwrJl&dwbf?RR`SmbCn%;$ zT@Diz$<5J229azlQbNlGVesq8IL&1;ZWAUs{Q$+xV|0PHy;!M<6Hfuq09;-gw6^>K zOH4XIgu#s4CmF~}9@&K<9rH-v*0Ar;FJa(AjH@(FY?*HtV4$WUWMrbDa=WEo4%0(A z)TXQ4Xz;(Vs;Mz&zr$pCJ18hfEDns5tX5oXsxHD%j#8n|4~-=>{lnH|i zt0Yw?rwK&!w-R*9M5`vbs1X`?5_Yt>avbYye!W@c|3Gv%TNy1uphdy$Dt4*~* zqrmzp+JBrfg!=_GQExuV^xH2>-uU6u%a#YnAXwW^}$oy{v{Ta19kk&j=| zzPx;_tD9p7k)vaowl;xy5-~Or_&qdPh+@)#IeO( zV_<@-pu8L#!}4GtP??-s8t!8)NtQj%=6^aMd#EEF_3{TyA5^&RQ=l|HUgPcS=r=Tr zc$VM^1JOIV3GMz{GzJ~9DtgwXO)hNy<^vFs(45VL!n#z~A8_y@9HGd{jA;!D6D{S9j0qgruWd#`J)t~BZHr7!(cT@rR2DWj zTKAg)t>E7xDGPPDv$K;7{kfCyzsD&(ti>M+SJa45f01-RCf-=TtaQk1#-SXZ*@{m- zNQ=oR7RcyhO(|1cFa1@el4NW9zWPg0#&axFY;AhiVUh7npPhDvNQ_6?^#gBe09W=1 zkSVfj%E3YYIR?mm#L`0ue4e`0o}9l89ww(X62$|ihGMl%H_8$u zp*4)w&?EyhP0a|CDu^d0p&VlL^c8Na;ApDZ#rTT%xB5x|4ammj_@jjo1+eI6`c!Wq z^p@z;4FY-aD4{jA=Y z@y=OCxxJ6oto$Yi5#Al=UPQ)%$mgEHk#M2&6wG=ppSR zNobCV^Gl0N(dNdl(e>0*gx4nxvP*ho0P(|S2YY?0Jj|cRIozWU_^~RiH9J!yEL3UE zMZt+pF(4)5p=W;%>S$F@6)VfpHcY6s_A8U2$!x^zKa~&q0LuNLKn?sb#bdkFg14kW zV^v9f2b&6&(U0Z)(OU^3o18~kH;RJyR!_Z9?dyqCP$Z1gC!g^FMPFTZ5h~#0Z3;0+ z(JJa0SduUoq_x7_h%rUMNeEH~+azUD7P?zlA}W{vfc1mI&KE_rS!PdpGMUl@zzOV_ zi|2R(EBLmKNO<`_jrcz=m>!EZIcY1Pd(xZZ7RLt5J96M!5aAB=ce-woUt@iC%}<9` zKJ!Nfb$5UU$1CEBKCRK3k+H$2B837WhMXV`0p$!XP*f^~6R02sfHz@$V;>+TAyi#c zA1#3!{{qQNDAKO!KQviy`<*~z{Id{%nom`0;A8=tO!`;p8I853sfHj|>3n2`9#6JjZIn{%kc{T)mXMwyL3DJ*-@#owICO)C!W~BAzgG}gmo-5s9=P2M zHB!VsP-U#yy$gOAz@;nMUSUY`-rOeFTxvOzf7VJBw8HDX0r8T8FvxBQ@v0_d5!NGg zQU+EtbJz2K!01OZPJpQ@Z288Iuxtyh_wkL?CFNy&Nr?2YJQQ98SawOtt-eZO+X&{N z$KNx!EFAVg%&af(>Gf<3{3iwXIKJ1gev!yWP~iXAP$B2p2uCPeMq7oQ2G)X<=tkd7 z-(h#*#fdzfXS!~Bwo<(;yEJbWCs`mll=3ahDqY7qCeHUmyBL;if?f#i-$C5DnRf;C zDE(R?Pt_@R{bLdo>D-M+W*Uqw@)$;jiKdkr^=#kA7qn(wtUxg5{8?M@)0e-@A`Ddr z0zMYSXAT{kl67wopZ~ftvAwLA?uDK-%snAHR)g2t!8^R0--``uXSZiUqi&iGLbIJx z7iG~OpdYnsR%l8@`yb%}(M9T%)}Tr&E03JA1+H{>Ci^Vd+dWxIbHp_E#C%CgeTTAD z=mG={NNgJ^!63l{@d6C}NbeUtTAqhNM>%nxnno&QLlLw0Np`Ctqext|D=H;9GlLP8 zo{EVRgJ?feW0o8h|1>qziw&BXc0Ery8K930VoJ2qoaa znXgIgvl})KTT_3wx_}RDv@N{NWLn?nK>x%(Zc}crITQu1Jv!Thk<9q~kpWFJM~N*~ zvJk-ij;TuKgWW?5ohJ#SlNg6-*`xMU|$h|r7kw->&d zaIE+rtR#XKNIEj&`kK^RuQX-Wnx4%`(DRwd)}osr@g|%4%A0oYTIe6JBkRmRAU-zb ze?zMfANWb;Puj79S<852=(3Abrd4HODAut=!YBcAXzP>9kO775Ga9pX(#$ z#b=t#VrrLTz+q59@(e?tnc+Jz@sM-SWydrWF2JM`^RZOAU9LBOB%G11y_V6qcc}VT zCsIgaCX!e($fktATm1-OLsxs+VcIy3KVV2g<)zsc3~wy8FJA8w?E5_Sb{|AEn(7NN z@+a3~{RE64#pE58TC|BwbMzQx2XFA`-m7rgdQR^eWo9MJQv(dnyUu>Ul6{<%ZCrk( zCS&3Wi*z5HbNe8@uy{1F04zZp$xa-I9KD%XrB!8%qL6omd3~7QY@{?7i2)W_E<$0m zt7J1BDE`Nq=PqmxxRKU1W*|#$(|v^NNK=4q9+{n1B@ha`cN|V?Pd88S)J9NHF=cY5 z!;~By!T!6n3#Y!yv%<|!N}RlrBZ=m;Deg08MH|}D3p9c(zY?y?zG656Vjf>)5{1RE z97jLIq)e8dhwAG_`-k(zilG=<r&D}Aa*DU?0!+y|V5!pYYMd@I~f}B1Cr9+id z(-~DFc~P2OJozgktyM)VO&3Hv-kOQii5l2NnED=waits~zsbRuBfpz4N+2{`x#I-Q zJXj11?mPBmZl<5I&Q9XXl#pM3x%!=5d0OCrYNbsv&j{nG4^o=yFC^f2O|y+3 z;~ZC#BV>ou*{NFx_76&Kekk$~nvmNyt5l{BN(@K6m`|yDp$+b|9`tI0;_PwlzvEQh z>Gb^~otdV%G(c}j=W>c~W{a&&8T zFAgI@8OAWrm+*ZSh-hgtRMVkb0G}&ePpQqFZ_H^}n7Z6?Y9GStMLL*ax)&I+<{zcY zJqkT|sy#VttfDQZZ8Sc5&$kzY&EOKowNvO$k`~wXeLiW?G3qb~qc6%Css}%%~3!H`ZR?ryl)nT z3jD6s&f6JxWO7e9?d=5qRhHefKC&qEmO51bg~n-ZIo2Wu9T3-Cyy7@oIHy06cPJ4Q zo+mq`a5tT`{qqSzPGOY0Q%_twTEDega{A{ZyG`W$^+?btkTc7NpgIacfY`G-G`^sn zKQxA7LA;i)rJn((&(+^mmS2Z}8|RSHANWHBCmPE;4adG}#j`lclmA+ks9L8#{$b zl9w)wjh)L8R_8yQ;1APpVkM0cHZ!$!8S`LsLr^vVx~{in2sf^mjLq3gFQ0r%YnU@H>TK4bCfRjKX7Z= z19MNtnbWh*BM;Q~*Z)CUeK#L@*iIY;kQV#>>mPZ(R(QkR6Z0{~$Z5+d_wUS3asB~I zb$9|eoS0_?OmG4JfW_HV@7CmXwZ6+*fE!1ij7y~8!(neSzX~DnSGR_k((dBGwn>V9 zhXDQ3hHTRmsliCF2{pz2zdVSRpghJV$Mg@P7!#^TMxvH3UpIy%(wDC09>G3OpXq6m^J!-i&^G*fHu1DcA5*Ekv`vpG~(3c#zQ*t~KdFFn}j0wpXUP zRkD*wSx0%dp)oQ)Pa|0b(*2t|+1sOGfKLz~{pWd8r{yH4NRu_A!2)H>Ti(pU$8?0% zDLNDOa&@KTVFB-NM>TBHu4(ZyBV!vLG~_R)8drCp$`?;uzt1?OjN=W4wHQh%luzrz zG7MUfzyKLGVJ7hq66YEje!y=Fv!@zCG<5gK@nB#s!7q|XNTJ&5XSl%kv954Hz3j#| z3WBKO)(JFrR$6-HV}*y2cD8n0TVOEr9l3v)lw_D%o1AniuAt+d<8+}unQgVZx!Q+uz-IqAl^z{{ zzm+|QNtxp40VKM{M9qaLJ&N9atzmipy`bHy6ea~q_wv9?0xbz7JVBG0RB>f-h)kO< z;Wr_!)rbBaT&Q{d7^%tcj@1UGl_H&9y*%d}zs<5*!{z0hMO8>fhS5}))Gj+tOV&x( zFxTZ-#h}kTE9p;TB?5ZW&TRgG#it6m)+*wp(J@&Knh}hEB60sHaFdTD z3sL4m`pG2YV^WP1S5WL>QjyZd@1qeW*n5(t=KAZNXZVj<+xzLEU6ix>9i^PgUwEj6 z)ljuAF4r_7O&f-jdx>R@ufkC60U;}-R)ns_ z(ZnpW7+iMDHjLTaaWYA{(&UsDXs&=MRe^-OGKA4-ne@?_DGt0C7$Vzs6%KDyfU0)Y z?1Ici;-oqbJWxG0c4Cv4#r95(T02*c9y&H{{X0Ed${}#2+^S`f^RfW6Lqo?-w5X5+3%uu1dI=SB=1=G$m=$i_^Q(z_Igkp(ELL6YyJ@CUQ@ zCIV_PUbY3U`FGE$X@gO%j+@r!BSovPGWaCi!DKA<^H9w7ffN(6q~rZ!w`5uCTqz^JvdNX9=piZuIqP;iQ{SWERi~t;1L#Z( z>|-PfY*Ps^ACAbbvE_cFm5NWqptFDt^nNIU>Nm)tfPDg0Z}Gl-0aO7(=+hst?G%X1*mq=fjK(r9tVFJm0wuikJ6F+!QiVYh?V(rajJ>d-1d>#O zbWKTBb+6DpYlSB?s}OWUAj)N!Dq7u68P!4tR~SC#xUrvu@ zTQ}_5rDV+vM9wU7I7EZ(oK-n%HMC+Os7=3--ZC?# z$r{5k^aho&whWpwvnAFAGa1DV$(QpiGQRQ+gbw`E86@Mu(Lf639dMxC zaIBm{D#lj8Q3AJ`Ef9eI;p&9>3(J>juw@gB`6y_d~8hcMm4V=@+hNoWRQ~JuT;n=ho zx@i&?uXRpHz=K|*D-JRdJqit|}=adBQj`U(oT4 zKcFh23ZR{V*Ut19@fbG)t=i8y0xU~HKKt5OMqXZgq_|pYf@LNw4%*oAcLfmHs-FU7 z4=O7em>60rgzoUWhq-{xV%3MclsE=XwTfzjwsPeqo#3s`S>hR0CH*5?hxfU1ObvMhiUcS(NeAkuH^I|y+VMeR? zW>+4i$&e0gbn#_(e&5~S*um%sqE)N(Yg*%j65=@lJ0aE6|GH)PWlN~~Ko_tEBsJ4k z@sn4t%kEnDcy+E;!rBth%N@-G`pZn60eF-i?-cL4jquJ$WMQzFYV`B7q=J; zRcnw))=-T%Axb{%`L4n<7`T#r`aJNu zZd}I2-fy;}KcACup0ye>swg;;a=^DeaVr9_S`<^lJN&9>v)gHzzh~v;u13ZlQ-S-L z(>>l--Lbm*&bKf(KPiCb=E+4uHIGHfgS?+LU8FF{FZs+MnSDGYt#|D5 z`O*rT3Fh3Q!GLO0a>5FME|wNSOZ8u9J4EcXzLD4AH_ejzCH!^tiGE#KNl7(|JsIv@ zhf-6pd89u3N1;lI0youUYSQiCy{~tQ{^q$yzvw%OmRGAZiK@QC`p6dVlu`ud?t99{b58=$7tL|i=t##g*CyI&*bkCV(`}~ZeXlF-$~pu+ z7JsR2!455Pz@hT>)`s)Ts9RyQpi%CDkqLw9f1tgxX!or(pHs@BBakw#@n1(CR^t7HO@aoZKP~(CQ#)~S-Lt1C8yUKfTF#7 zIJoJ6m!p&K4B1e_c0j6Z(sz>`2VR`N7nVq5m*mwbK>=;w-5w5FfNPTxXjCyGI@`12 zAp;MG4oTCeQ)gzJLf><^ z522zs?HA4#T!#$wy`7yTREsY)O~wfpqBgVQ*!MLNDYtl=iVFrSM1MLt4|eM$8`{cE zl7o-dzT~YADM7YHw-Z+n+~jnJ5t@y;rEV!i9ES1(|32ra`Q14@YEJZ*f}>QtJV3)yNFuRqvjHvCP-5bB^i@*9GOU}XSbk(1L6%c#03JJZe6C{%VJ)|*$qTzKy_ z2A8JG=;bXVDs|t!TOpK4D{4feECBnN`jIz&MALHp$Za5ZBuPtsIm`dQUJ-S64_YY%_*NS@Pg3c&>! zuO7_IIF@}l(JU3wp?JkC(wt~2(~Izrdj2<`-vBmtTj}iR7JomCRbSGgU_mQ&$)}4qSpGXIsLnAZGSSbt~g2y?ZBJ>5LBR)ALu{oECt@Dd3 z?ZT|tqxUXTwLN=^#eOd_b=10lI0>z2wh*b0gx43K>kBwXn`!MGro%u}&r%=m8(L~- zqhO=_wtoo>9)b0;;S@LZw1M^wHhVZoP7z+erHducdChn*>$UdvtGmJ}R$u6q!EfDH zoW6z=e?l*pbZ$Mt$DvD`L1~0a2Iu%bN|PHXR=BpX~dY=?rb#g}5Gq z;SP$d3(2U~GmL*b?KyAuopKhFM>2e14Plx2Js_AF(%~9YC~F@(DV9QB7C%*G_ttLV z(QYXAa*Ef*_S#;nPla^w3b0(RmQ<24pR~*GO=v^F`@q5#lwk;~FyTTV6>yD~?p;Dr zx!!h&``g4q5wST>rRDRcgEXzv7D;J?wfkU>rn}gShcte+{syTU9&ZlidN23F(wih{ zMWcF#T+)6Jl-)CmWS+C00_Pkxe=Z(ChMGs6W7Fv-2f|@ml#;2i!>QEx*fdkV^ZRGu zX=(W5*5`WBs+dO1-skv$VM<5ekaaehHkE*9q!nAGc?Cu*)hlZ1IE9f+2y+z1&S=-e z!(>)>y~a=hNetG5H70)hqE@GBE~#?4V%8drW*Wguzy%C*A8o2DU9A$4tAfh$K{uN? zqJB}A>t53_W=Ms67WQ3;$pdx469w7yucBRER|K_3_YACCRu$EFkyaoml{)tZK>Az1GaAK(}ThT>?vKl z7nw(%RUCDy!mmLv3L1ZPQH-}ijVp)@;r-bLfhX!jfLX{o869wt^)k?A9;$&;GSz$Y zwNonqyd&@<b$lW5@|gLNyQ-~fd85!+v)pUK+g&tl;|ivl=X4jF+eeXk^k!b$ zbkxmK^w7rgu$3OThxtK8E0wC-CL^tewp2KZ*VbYYko)$dzH2C= zK=FeO+gjteZWWdw9L}RK=;j1u5iiRy&OsF5nAt6_e58 z9UrHW-oS&heAl=wzJe|bl~f{Kv&VQiG0#IbdImbv5>3wfo}TaHdU@k$u@nB(>3xXt zyW3FJy2C^R9FjsQ{#8UV0`w2nlY54Ev zXCcMpTJ{vOB9qA`s4qcf3`hJ*20g1LxKl+7oGIR2fJrmj-yO5MB;t6sq@av%yD=E1 z6k3L{?X@l@BqNWx-+cLxr~62|nN>vNy&CbuR3-W*^Z6j35R*J1;GwaX>msmSy%%pG zuV`Wnk33)5fH$#f@;2}9Xu6GzaiF~DjKy5U6lv*avJ=t_8&(fQ9}@yn;idNGApH!7 z%J(F!cOWtq3bl^8khCv)!}b=n*Ii&QSoP5N+@Uq`a?(j}j2Wl$=y-F0H{p4(JX5XxdftH%tLv6hBA-x*(EN`H3oXj< z(hP>M4L+wpUUW%mLG=^%xs*T1$##yM_fRrlDkKgVB~H~g;Qi!ts8gNKsqZaH{RCy9 z0Ed$#F1=WKIIX#*>Lbq1xYuG6;FjCB$TG0iO~B>Ro-}9S91-msvc|x=Z8gr zF#K}%B>B3>eD7xvmxNzZ31?wG&{Fc#1N}g(_8E)rWjBSG-@Js7T z2+5ZUQ?*ngPlmwwgQaITW2SE_t)FPDr^@Hv-fjt6Mkh!LpD)NfywHuRW`CHVZ^^ah zu&!WIsvo~-rXJM%KAhB+a>%<{>f4t#pj|u-enL2EcMg+X=)?#1b`GzYEyS6BlDe{J zatq#Iih0*c?eeE*@fx1;9l8pc3$h&qlfd80eDVF1J9io3M8Cyz?_qbl0WgJtUj>ii zh8Y3a9$#dt=6DM>eMu$}PaYhCml^iak}8w@oX@#v4mQ<``ytIZh0mDJ?kMqWe0OR8 zZhB%Je8~rFrnBAyl@%90S@9vsUA2fzr_0amAy)*s%CjyTptj;>_~nT=@WvK&JgU@k z+;7yj5PG>F(ySmXepftbVN0=VYH5*f$<%rgy;T6!E8CMgQuuAe6M8h9!PoF20YIIa z;m#0}8Zz-`G-z{~WFZUM^44e%>EbrRLuuHr!S8EE_bQ=k9TZEquH0Vsi4c78*FV*` zb|@~se}~GM=#!@irPB~C8NCOjDcn_++^s9leS%T!dqN`Pbq&)84=SI`)$-chL?0|M zFQZ+RHPp=MS#`i%QfUV08~J=k*te=b#g(}xWYH+kES}4tneee{bxz?CzN1{roXAG7 z&+{uf_|3s_1azm}uIlRphEKaM)(nAPu^5zc$YjE^7rORzcg6ssLPZj}Xg@*aZjg97 zgZhb7{szyO!M~E*AO0p!11r)H+7q>aC$mV^DuE zl8QX8QoE|xaQU-Mf0ug4Sqx*5Tsgy>6^N+vCd$$^`Vdq69FHx@ZTl*T6!1fmq?+Ta zTXR#=XDPzN&#E!M^IrF|pZPRQ>~D!UEgK0Vo@qarpP+zRjrQdpM9|f{2eS>@o4>Ay z>{5^UJCmAZ#*1Y28rVKfL$%-yq`2E-G5SfZ!Ie%oA2$?yEWpYp7KZjj*O+4B0T^he zQG)3`W7tn+#%t2DZMn(FzF)-D)Y@{+I-J&+1B&&_pwB4zJB;m!<+(NN)dK7f`A{b3 zwAE}&$kF^9_EBH1%={ArSCxiQ;_w6$gZLb-P$HbbG2D?CXh?@&H%43#TIC%1?jn^i zYV0OFe<2}FdXw^D-7fONgj?Rkh=gXA)KMm#auMr*-VmfWq+u=IUBhE+0j+WE z$`SBPHH-jRzV2yD4RBO z9Mwm49D6Z@HeDW#`NAETIhI4X5J8NBH>hkuV*u+PuqX_M7eE@UqJ$q;N(%D?Is6%3 zM5%%jagBaql{0i&!IGT`W6cS+cV+DXk-FkMmDLHN0vR>`{-y^F&?~bgfT|U8rB~<@ zrq2z$+45QtnOS@Vui|mY1g2fyVtn~TGaqDQTv^)diZqPW{*N|I@FeYyoUc{=XhEl= z_!PBWo)QLu^2v!#%S!OJyDnGCnaSR+q~2@v?pfXs@stAyw?+4cJA^7>czaTZy&ZID z=r|e1ks2Y?HhmJc1q&8Zuujw)gvt@Huxn3<-DyGT@ZY^b5$y86BG?5#FSTOU*%p(w zd(pKJxdmEAvKO}xwcXF*YG3a#wqOR_%xq1T`Hju>*QC@3`p5B-Rz;o7fP$D=)Zil{ zYcPFC@5kXzAx7YNtfc`XA9Grzzf;)F8qH^I8l6)@X_jC(k8)KT>9U<4rKU3J1QYeo z-ir>ZS#wH=e&;>Khz|y%L8ITXZs_8j`!}|W_Y4af9T_b2@ zT|>Ia@){cmya`}j^B;V`v!*2`u4Fv(=7)p#U9HOM+M|tnL1ZTa^*>8V%HLbF5!6Jgf(E zJNViv$6P_ei+z0edGay+!`!yC{Kd|qsb#StoH0Q=3Nmn*%-T*+!8im4VR)uwYORGO z@}G`={Efc%zBZmF13aaf7>_=qazZ-+t4x_Y@xyS_y#9cR2h|jKN?;auC!Jj}XLD(4 z4hxtJQ&FoeK6(5KS#^tdKg3M1L88g;YQb9b)cj;;ex5FrwvX^LgZ$SO^|PmhaiDx+ zqSLSvyv_>$eiYF?89c25o6z}X(ul2ZL72`e$}gdFB5q3sui$nR{O}qEFO0|PhGf{;pDI#Qz`-sMsRo}|Euka$A43zP0SA)w; zX{!W#c^*GZU^CMVvv&nbVW=Etop2T`#X^ff00${%!);yITq5VIjj&dIQ2)Zw@ZDb5 zi5Q?e575F@>?{msdr~nXN;a+mlMXfg1{3<;htPn^vGD~)Gc{aCuOl!dyZ@F?uT^@k|4_}D{Su}2&8@Ck`}7fE@xmEBcl$!!-8zc& z0P3dIrQv&#AhyYkkFN=elB&7c?3UnK;GRNL{SmSNXQFToWo*xpr0w#f;V@R5(k4ha z#1uk@r|`a$1?o?X$PVlpU9zFPHz}scqGW2u|kOHX8M>j zl0DNW&zT+By5N@m8iB~Y9R{22A#L^j`T{+q%GQgQgc@dTuCf%BQ#b?P_;XO`$bwD- z<;{Z6?qoR_LPERW{Uq*y_N<&e9KjerlX8v~6KNmqp->kYgaVQDnUvQ}h>T6v2Lz3x>`Agp>JKg;)}NO@n7j1VHT$6~Vwg~t^wxhpA{j+Su4VM@;nSXT zZEoP!wILDT4#dYshM_#qtTGyWfd0mAizvtG=lu&qZ7Sjr=EN5CaU^uOx=#DnQ0p3- z?u{l#KUr2s{!!W2-JUy5U_3ZoP=&`Ra@Z-9b3!seb}Elop3t8ck3|^lQm_%TTVTt1h25 zn2e=h>HZCDLWj>)laXF2$2$U1T6Y*&dtiu*IQyqs=TC- z%zgr_`Fm>0pDMRex&Rr5eLGp(0Jlvpnxl{>vR$-m4i@(P$zPS^aa%LF7!dg+Fw(6o zx1oEL4NrXbeY=QXEA8$4^fP@(MljDB+w8r5f~JR0YOvp4Nk;A+)!74iD}b)nt4q1syXXj zpsvEvT{!iS85k0cn1aPJn7*UGfzX3d@Jc_bFzHPR^bQPj?AF*h)UA%+#_zk2scX&F z@g&ZI%gLEzIvye$>uT?%d+_x*i%+S$NGpWtW%YY{9-QV+wmdW|p=>JgY0 zyA{A?q%DSEKG$Q3!13b_8a7Y6)mK8s6dK~3)U};<$y^CuFEm82!sn~-`cClK1|{v* z7=c&|jgu@{pGl#Jvt+Om#SC^T{@ec0zh}$&T=< zv_zDOl;$g+U){yGc`{%+5k9TB>=N;w-GhH+ScJMpQks%~wNS5V@J|FgF`7Um`>cgf z_oaz|G1(3P?yo-yhSq>Wd9c^oqO4wHnbhwVnxiw$Gy1+~2*Di?@wZjG?nI%`(|J}! zCYI?>%`-$*&MC_5?M;&*+batVM8nBd57M%J0W~K9$QqRV$1~=+qv>=ROGA41{rGBn zXoSk?6iSt-*@XiohYU0uc(25G7q2v;**waO#)e3XN50F_=L;L~KO@tmRyxp@YD0vA zO%KR(T)Aa`^djT>w|mfNfXijck76}HT!h~)zQviE!AM_HJ+7f)yk^hj-d-%M!K$X( z7X=g-|ASfV3Eoea-qk8)ao-hO&4Sdc;u0)!d_trn5{bDhV=VVWNosz#jC*qEsJ7w(185n8eK z!kwBjB}#N?|A3)fN5+^5Ud4jNYd^k-4;lE|Naa$s47B+X)M<%?G=x0#?Dye9?+|Df zqP`~CmP1hM**7a>dwm&R=aFn}$pSXXb@Fbw7yvl=RSrF!(~it~nJ0Z7p9ZgZtqMLe zl4=?quzj!>Ek4OgODW&>>`z1rQywz|+apa^e%0-=}$YHHGk=sZ~-}T%+7-n`?@A5QXkN_FmHWJG#Z9Cp(kCDKkk|09~B`Ut^NAx&?o4V6-H zD3mom$R5`)GW)9#DTaut828py5#|V$+s5}tv}8rUge$AMPt&-r9=e}CKdpNf$Hsn=f>$>*347Jo*t>Oe*0nd;hv%-b@(OzhS zv3SHT+kgnTUL0JwQt0$RSND26%}+>l`C{X`#?npaGx2Gt$+jGdbJSVZEH!wVQ&b5D zFWpl0qi#{St-1DmA&zheIL3bM967bf8oy#Hzt3~*3LqhD+&zn|jM;p?Ma1yoYZ3cy zv1s?L40j$bjwe4XW2|ChL40f$+KfjHz0&%ukx(&IS8l+QHFMl$n!a-9lBi}?LJD#I zOG(3~KOxHX%a98im%7me=Tg{4PWKLBwz=fD0ouv*lx%;AsV9AHjRvYR!*nb^GpX#s zwg!iVL@Z3^(&e=d6JO2etT@!aOWh|ss6Sw1tROjy)IV~T&k%5s5MRK-|93eH2`Y<- z3Njix>%a6YHyEUU^(@3>qNvot@#r@2Q+THxaXWeR@>+~fNyND-IF9)j`aEr&xPYyrtyM7Lcam7?U9-cJ+8R{W+F6Gy< zk_Fc)Lyxt>CbN_(tw_LWMXbfG+=Qon)fVp43iQUhp^blQyCSYnM(ZL!jd{;ivt?Pu9UD<5a1MhA-DNAp#@ zsd5Dke&x!?eqQ+c7e1t=uwY!Sj|G$6r>LzjXQEBD#cPZH;kCS1$YSURi+CUy%1{>j_yDe2r;EvjTFa1UivM`@T?))Y6V4NQU5B@F&%BI~DWN z*CUQ`kIma$V{?R#%}3u8RSEtiS-Op*@p-))zz#$;NmR&l0c_2Bllnl9Pt(N%4MN{W zTxEU^;~3&_9wp#$ApQXpWufrPrCPhAVi1qj+!SyXpV$=h7RAmLYo{Yy0d|Ypt5Fir zT(GdH`2$Y%X;|69;Q0LX;GduN$K(D5a z>#9?R^fNu5dyN>9kgeh=X;{9&$8Tm;ESSpQ>1WZ~tbXUHh%^gDU@)nBgkch{m@JcN zQRr~~wN6>S1Ver*I0x=uf7AQc5~=)Tdq?z@OXWha7CSD?xhT=EJi5qKM~u!!^>*UXk=ia5F2`ucGPUa7!~C-DppNhLiY^$B>@X(%+$ zzvqHmD<8=@)LJ#FL$f-@M9;+^i+73JIcS`TW?Pmv4u`ZTSoFRjGpOcTFcj~F7e9Lu zvhSr&$-80QjqWDy0S55<>~Ad>gKEPuqt&)Mx0V<|M~;gO_*x;;mQzRf|$u6UVV-4 ziq7^EEIWjzxhR+6Qja%he@`r#JeZ`IOJ8*3VJgmb$pa5=1zD53b!pD$j;CfgZzt>(<2z4cp1x=5lh zoHK#y#UfyrxNpPPVJ{h8V`;$i(lb8qyCO}3VxiLPdAE37fNa4YdMJG?)0@WgON0b! zs3N~hvDsV7LySn|0%tG{#U$_aN8nr^`yVjm=vc?WeFsx#0q+EKdcdnEPcy=l0KF?d z^2CX+KGgf(d4(CTY`i5K;jB3t|M(&*H@=n~ul2u9@c0N_kKl?GP9P6G=rNmf-8Py5t?H z{<+A!SaukTcyQ`#>wu_IzSI(RaDn*nuJ%D%K>WyY&-gNPys(mjs=~GenQl;Zyp?TY zEgq~!eNaBDjm5b%mljuUDL>JMx3i1>>)2`mCf)SxC3Y@a%icaaa?wA_lWz8W0#Pu- zyNFh^C@rFOnx(pMU}`GP3RmFu-QAIO{0Lu8Avzg*ygXAuAk)}I^;_?6wIiu%oD91U z2Ls+l6q%ZFjl*9UlIuE+i?zK4NJbfEH5VPK{Jw=cIdTJ*|BJh~jEbub(nVtgcL`2# z8h4lA(9pOxmc|=*mjq3tK^k{xT!K3!XprEp0fM_b-{Jda&Yd}H?pky2I%n3o_x$T# ztM~5O_10T&)l*f^-o#>AS#iHcshWChdW!FF63U;M#8v=Mo^wv!EnXYFyX|(!9e1N_ zGssG_5N2!15k?JdYE+5;HHu!&e{$W!IjAT1+=VAIv72MJc+|K2OC)m*8i~bC(^aKQe@}g~mqT#j(=p7nFa0 z2=hLXyRdoXI`+-}5sy7e7vZkA;_=pW4gs5gwskMFy*pn;t&>!Mk@v^FG_Xbih3LWL zVx6oj#;{ULQNd)v{2X7*;n*~{2gK08t~l#w>UWpJ$>E;vHiKZX-Gk?`xVI81@nTdc zNr8!sz?uCXJj@==)2QJVX;;9;+ei6hEHjU~K(>T{1VZ4{veuJxjVGphC0=5VKJ90o zLqdX#92{2)pZ52QsYSF%_;{8Zx?Lp22z{aC*C4^OZhMA5M`2E(ps8gYRp?op3ZyhK z-fb$H`my=(iNc#51TO=QA)Vne4QCM)xeRo8EMH3$`0R$CW?T%`A-(|p{2U3|K5i3} zW|L4&@q6^K=JPN3=dyB(9zAyWdu!mqr-*^|Q0$Drz1My|^b3p}Ue}xGiT=R_t6ikU zB|^e9Km?0Mcch&l+C;E(oq>)qg*Wedsxy1Oo&fCDvYL;Jozwr&Ea&hog9TNB$ve)V z1UzErg~?CW`Xbu5ce!q=imt^7)|wVwl{v0Hnm@(m(Jx^QD@xMNPYUSZ zoH|#r9pnrJ*(;yXQ#t#zV0A{B&dUsGxs8{YKHmG?o&CTritvtZMBXKY;j;*CU`2Og zer@pu3aF@u{F!-_Wq)~;&vS+wT{u1@6=>>ud_mo~=$YbkS~x{fs9XrC$i{6!gX$r^ z2C5yYU9O@2zj<;0bKL`;k*D9D0$Nk{p890O=V~*5p zEy|I1=M@NPjo$epAKgpO1tlmv8HKE@)?sIv=$SSvR8Xp%xrz{o%W)A=T|qYSZtDW5 z9NKgi$cgmYm{XE5)A?Zwvc4D$Yv$DYM$A92ZEs{Ux?}O))dnT)R;Z&pTH0x@6+g7z zoxSZ_XR-5j_?nD37h>|40sn2LYI4*$xmZfO)U8%_y(6dDABOG1_JAaU)XfcsQ$DBN zH(#C^1E?PsB(Up5lyhfd$%EJfq1DG!);4nCQV*NB1p?_=Ykz1uO|yI-P|%l)wdtNk%E zgV?g=oTCtQX@vIEjUsbA3b31$raWZE$afVh-u5k{ykP&Rns?5qZ`{Art5T66TfBh` zlmKsK`yLT8od09UMqq^bW`Hosz`oCoAfaPp7bOKcV$*V3q{^Pj3rn=SiLMr+rH`PG zzh|xq%WutzHNtVSS74DLSoD7ySIHR|C(-KJ3yQ8~R6B@hG2h-w+{b*w_>sgv*KKvK z7)lO)<%KIg*sy?CSC!^Pzqy?D?D`$@@w^yz+ZLOTR8!BwPh^@^{|HO&R^Nh|wVKlm zG7P^Th+rFW*Cya8ZP3qXd^BAsCYqpp#mLN~xi^vOR5o*H@+mTs*hmQB>JqBCB4^Fj z|BGwnrjG>fkgCi_65|p&`eAvss*Bluz9k`~1k5xSS9XjCCn@1WreC7n#1I@|LL@e^ zR>e2o9famIi$al?#1{HjLKQLUICXNg2fdh%+>;-_GPRnc9Ix<81 z-aQ5i3CXG#xQfMsnRMUEJc!+siFJZY0AfP!lOcPDB~_Ngf4!KT^pDg0ah%)LjO{Jb z5KElc#rH1RD(urC@^6|V9zb|WTXe>hob+EWsxQaU;1>FcCt`@+Oibs&E&c5W2qE>| zBuXa47lNW0f%2i5i&`nJyJo4>VZry#lYyci744yrT^Q66M$hcFq%fc4E`GJ~*Ndq; zE`x%~IG)~p#bGJ~c_VJGQUp^b=KJc$6>s7|;wdAQh*z3(qQ_Wm8~g0SWeJ@pmD=!q zWl~qqCazEtrD++$fb^7p%}SRTCYuj8DYA+t6G>zwy)Fd3M2!{uwG|uSK!rag*~K2e{0Xb06u#T4~%$~bqB`i zi_R6MssuGShsQS*eisf$Fpz0~K+hQUzmQ?C>Mw6P8Sb*u)7^{071t@E=dENb5SL>)+f6EI zTW~ji5_$~Gt*R{NEws@JRS?On#D+X8J})4KZdI#wr<$?~tuW_YS^b;&{hp1-Z-D~7 zB?_`FITO8d5bFH3iAtW!0SSut2%x43q#RJtWtF0{C}m{tH|;d$G-PY7qQz(XI^X;3 zxyBG716xmd_xkFyV*&L7I~@|ybsOP+AB&bJ0DFgg%$>@>XQyx~3(-Mk)#iwkmWkIg zr#$_6sXW&Cz6;vqA#+*^IM#l87jXno?zYsBPjfHZ5k%=|(kf$_NzoR{FJ2H!llnaI zTQfsL>67ueL=0mo_fqN<9cGKbyPZYU5`OP4`aLFSPs_wXE@3+<0tJMd8PxXFIhIfa z8ckQ?*FHO)M(e6KFMKfR@$McLVeMf1lbDs&0??$<@GhDzrV23=22w)tD{?3(yd9?? z8muhlJPI4jN_I=}?y`<@$x?WYBR|9g^}LGt-T3-hQXR8Tane#B6+@=L!u^=9;trt| zgy;CFXU7p00pPGV8KvyGwI2^d%oI<`Do|-VNAOB8bQxsJbJr6#&tWB2e=EOba#j`@ zpFb=lQ(7mdGP>_w7yy4e`r}+6l<2ODEN`t2z6A9un+?$^!_r=z6r!`CY&a=Nf>&^w z>&-eKOKPB~G!<%AlY%)W-Rd08@+#Vs@1zr4doB85bjKl68RUQZaJ;Qc5U({pcZNR2 zMSV@$6PC7-l)$|R8Ro43;$U6|kg}oPwN#2tVOs6b&P}0Nqo&qB=REp1{<&U0k(!d+ zmi<1U2l<-_1mI3-Npm44zq2yxop>Ufi<0O;zr(5#?icHr$>#~2!b293qa6taHiS>_ z2AaBIV%x>oIR8&KN3JhcnwnY8*5XIG^ZSC@JXfVcuXnam#xorQNAUe|y%^@ZY!nt! zp12W;lW*F^G2zX1E^*NC4^rblSGtnY}T~YS8R@ zwFNgE{1yO=_d!(a`cVCJn!M1S^hu3b#U6(lx{zWI=?RU&U4du!&Ns>7OiED9^hkB9Y5M%O{YI zN$7zRkSWB>n*~**$aGv=*udw08p)b1Hc=;QHFZTo;sB~IV)l;!Zp2{P&XbW74Zoy2 z{Y)dy82V}80xFZ8Ic`n_^xz&69o5~Cg7?-jNRvsRuDoQaa^>C93|CNI&uZdgS$;nd~Nl9U*$ZgS*v3$OBlv221 znrqTPWJ0;Wj0~`t z-d!t`H2c%$wdIJ8PvyP{E<2${bCyJX#{ifM0LJ$-7tfUyshx|5keeyn?NBo}ejvK- zj@OD(7%(70Tj8dyv%fUMKU109B4od+KHYr^<{lkR=M1X+;pLMq!k)>fuSOAG0XAk# zFQVhE@_!APpEJ8zF<#wCzxqwVe!g1lq*=NiD;OS8(OGL}n%2vZmy`wfBE)Ej zYV9xk?p<3V#Sz#YZXGb~)O39Zy~$j07W-n()Hyhm_s5RpYkaa%o;_hq|$dAowAB1yqMWkY|xHJ@8B&+`bfhkXArYIgTjwtqC)UoRZ2 z`i}`)&g+h|oW6%8 z&1VZ3K|qj@65&9bP{K7}ql31)l})=N+2xk3N*rWAR^HJm=z&n^9!}aU*KV@(9j*L~ zUmG(;rPbZfv$y)?lY1X!a(wYb;+T|l5)<7^ze|5n8VB{=cahkUxY(TGXNH<5ws~_6x6OPI>wBQdRDK7h%|LQM6s&BeKGyX)8=ygFMU7y75%P@vj$ZHDDwXL`t|!7T*g$KH9jZhHQ^+|B+tt{wo!2Qt?lMZlvOEkJnWB` z-^ychdm*e%o=m)oA*h~<8_>b(W#8b{C&D8bPH4SjX{EHugG+4ondBTCPfI;69!IHs@vdVyS?6JH+xK8Ral907T^H9?ss zj4Hzan13UcJUpR&FQ2IGlyIiNp+vzOOVwH4nH#!e59qZ171gOAT(c06#iiEw+(1F6 zhC-&AsA#6WyEDSi)-Eo0`ekQWMadVaWL)bwC2;j5%14*F7a?_9avkfrG9GEmvLW;u z?c1ZVAp!GsjipAo?yb#?cy%Nrz!fXcQu|MF2HfnozneUZ*|oGQW{X|$_lqv#hO9Y0 zhDPG6cnLf8YMVC^1;o|}MX4D0)txB5YN}i4OM-H!h$2+EF6680$gLk_uWVGXi1$Nt zXZgA@bekMirxG=9-Jlh`q2hKNO)}X*Kh7JvY`W1{1|tFQ<_`iijX&3( ztp6@O{FCNCVu*xI3TNpG4bKTY<{l_276wS8ws%?+-ANPri22@nYNpQRo=N!jz0XMl zc2`(VbRc^sZ*(R885uc^K}WRRUwL24F;%rua&wn{BVXsw9C!8YdsijeC=)eN6#!kF zC;qB1G>Xr<2h`4zG57eg$@;Xz6NNpEqUS8E_}fUbj;XMp=_<{Gf#GzPOy$ZK?@s8Y zKU;9Col<*$zRD7Y=|U!7E!}s;4=bp%tK`40q{HM7yXOGF*rRW`iP4(8KHX$*2o_Kj1E4r72{$wk7DcH z>;2mkw9=|9#+;YbEz0p*RvIsb(xX54n?jE?IU6hNX;gLG_Ozzef1$cvWd@Oc-x+_{ zuHC^E30j2;yOd4tO!;-F)dA`WSoLE2!vU|#cy2p)^G#IN2s0Fxna+fGgK~doeUalR zL4bkpqi0~yR8~!f!X;25Uv$nft_V{zN$8MJg+wS2g%tQ%h^^pNa-vRkH1AIrVVjXd z8Qt#gvCNROwATJC_a1;co%BJA5Ajt7-7WU zDyWtEsxmuZRWGA(%3@Vh)9|!%>tqb@0WAXG#-s4N{1I|D58(mZLD44;6P0b9swiL1 zfSoHF{!&sq-cO&uTac(v06sH)f8+w?PuTLN^ABolmV-jO!d7ll<2*9fAb+gmFgOo} zJ{M}b6DQddTYgmvUzuIVFZMYMa&QPFsOyf8rN3$(2&v4DK=A6uhexO;S2(rdJS8`s zG@2_+6mTxeSzIm~jQ+%yW8st4E{yD_i~6+l;C2^$(cgVQ{^T@6TcEW#mI;d4M332c zqUIwPQF-Wda~xwgZT_-c`lMtg+X*{7+e0vEMxZ`thqS>|?!vCNV>=|-#++LyAB)bi z-d}w3%PWyfD<~bscH5)X-GIQAg_G1PMkZOmc4G~ zyku$dK?+UyoOum*uC%p-T<$`RdLYG2Z<7KFIfA;PjE}=L5^6De-yhYMCRNI0k%KJF z5(=1SBjk9EDB!${FXA12A9MF=N7+=EEL~yVMVW3$Hc@ozaausl;^08^M_S5UDK{eb z#Mo5aUX`-IC>O>2s%=b#7IK+3#G0g|fTO-jDdD>KxnBVUezVS_i-Q9%xb(;oVWCHWmR_lNXe=5$&?tiuKAA1|kv^{6$%-rXR~P~s8Zm8pp^*!h{Y%4C`^z}n8A`TnYxA!mdx&H$fwg@k2CzQS36 zwL~a%s0s|q9Vko_X5qBK_`*kLr>q2WiQKexBH1k=Nm_z$W9pj-mTK+SZlY(Q?Od~6 zM5>he0r~HUl&X2$AlbhjgLkddl6Z)!r(dPEs~^lvI^X5yRdQr4-Bb^z;&{ z9H>a`E_+8&t8jO3BFQ**s7oS>*`u*_?HV>1H7yC&WSO{Z)zyIklX4Ox6Y#u*-7j{< zb7EnatJuF&LkbUC2p8D4@ik%xgnEV^oJyUn++8H>1H@HVo`(ibiIl4k9idS zv(trpFflHv9!EvdBuib7n8!@6$Uop~X6`$9T*KpEFI12j!FGu$f9sPpbuI<&*AY$o z1MwxpD&p(pI$N!-igV8h%d^3fgxbbFioxAs$*}4CXL>;{SOiG_kTUjbID*U{4E(J6 z@k7GLfD~zK$27L@ixE&rk1a|6SyO4I?YzlN+0Yh^8HP6fY#!MJS&s&1!jT|FHYtFN zKb!hA%1B4*dl9F*Ye(?tX^@6nLM5PSpihG=QzcnpcC~X2nRrrzH$K$ln|H4n-munW zPmZ-fEA&u8<=dOq9_Sk~k3e~}NiZDFClqaYwWF}OZ?1J}_-8VdyGW7>f59(L6Hg1F zi|B)54vrpUH*!QkGtA6Z=Eo|Qv$s&HtAFzhV}7$?vwMrFY^ThD2?Y55h|4^o61sZ+zX8{~B{R;H??jz^e zRNRY~Wx=RAxXk%8=+hxff!sKP}`7Y{!k#nt-Wm5R3Gt$bNg2pb240{$epQxQ^e zB#Q2Bk!x1ks&{TAKDRcE@Ed^{Nc(D`piFzl9+@MSVo;GJ(TAPcjm;S))=EfE-B?Q$ zPy;#_V3MeUqucfnFGeglqrm*5-k^1a9F8!xM2|Xe+*3PT-5VESI0)WL_SIWsrxx9K zYajAd%=cEV7+JxX@rd*LdZ4Lza*PpYhaFU<%1>jbelU%2KyjS(aUVN_NS9TK{X8M= z==YVcZgU$d(c7PR<*}15-bA9nQw`I1QXIjcbqGvUn-1Pk#^hCS#Ce2YnhOSeP+LK{ zTVP5th!bSk{?g)(8C=lESk6#z0}Z~lzR7$t8T;CEiAr$l1BN~wi#Z+fWop=kO^7Ok zMut^|`i40aE)zJ|4;DWs;TPoN&Cy>Lo@0evq2J2PprzUiYaAh6*qn!_xEOU!4%CEi z{D|Lmad%|7z|PJmZtz!Ctw0ms_xA28Wy6#L+{E3Pe@}ski-h5X!m!WfDb%b`^uk=U%J9>1U> z75o7wq?gVvFKMkW8-z3k8j@cRu{G%MOJ@7~%{{p<|Mh|ij|c6!C1$svS{$sqPer90 zWdbtbu?bk&$QH}rM~#Ds&|<46h>3o}Ju2eaTqXW>)s>d$Xld1{yJ6p3^KHYjM<$Cm z6)Mcb7J9KKZo(8uR$e&FWj5h>GPI3fJ4uM_H6LntS(pf?AlQ$v#GL%#;;-{GektB+ zcHv8{q-z=_3-q9 zUq>~}*5TJMvo=D%ZgausV=*HS0jp(Co)RH4dtC9Bs=2mJJWD$GkK~xxSQ-r6<>tje z%E7Nj&D$G*kb+i3TjDcx@i72+SWVF&34s|%vE#-KJy)c~1LYx&g_*mfYn61IzoeYa zqU8QAi8>o+m_~vKZUbCG!!0LQ&-Z=ca;atP!++w+GflQgf7D6w5xF!qu0+P<0?WDoXyF6Wfi;3%7@ZI9s^{T*!WlwU@1PLclFzU@4BE3 zT%*HuDrr!!P-g+lWDGLkMYG}iFSI?6gB9Aw@{@l6YPQ^aQQ5}Gg$M-wNi84^8JsT4 z_ced((_rE;r(DJ~mGWw#lc3;XDyR;T0k~|zVksk7jJm;QN=fyB`kC!Bi-|cxN;yl# z4SgSZZFfc5)~jF(g)H%kIfRVg-7GMl=W|Ps=;^$q#_1#exQ+iyH0#VML>mD;h;Rv2 zt;v)-N&BMFCG~7j8|h3TlbUyMlmrM>AplEr-|b1R;7yq|5!EG1+KKM2(#179v>p_%cx zMh^oOnL>yKwqig<`6NOci3Wof`DsXc>-iJ% z6m+f6>QqdHqxRg0HWQjGuJ;3AVMZm4v3@&^r(#)7P+||wvn)U-@cg!C1us6$F{-Fa z=3r#^9F}TjzO0Fj&g7Jwu2`-6dQ-ASy^@!aYBn%YjkCq(m?$goL)4}5bB8aX9h3FZ zN-yX@H(QyW-b$8ci}M$?RztFoz)^ARn~Po@&jtKSTuJUkO45m8vrOVM$qTae=KjC!5LuKVy%-Ybsg@}EVF&;=9=CStz5wioL#a*cn{ z90BqH!-Z4f%O6a1t(0}Exy$ekeeHKF>^)cKJJiT%RTy5(yQUno|0@i255Hg56$6Sh3-2~wqL%lA*FUHIab-g@o^JZ>+;Jb#d{yK_)+VF4E zYk^;P8bME|%H8pGfm>V2?u-sOw74_vr8i0@yG6RHs?RpzPYObZ8;B5k`%_;pr8=t$ zJLIFMTD03lQK|8q*(Q04QJ9>H(B!fWSY{?u6~vK;USrNc2&S-{+i3I)Z%ZCfHNLvV z+d};(*xTC<(W3TWY$M)W(|EgJQdHv( zG$gaR(RkUhiU4OWrGjQvkfLQzEZhU@no=FrEfFSagmm2zPxqzzyA^uD!(|@S8AgG z?25o_lkeXDUh;OPre2DE!7(kn3l4a@%OBdd-?_(>)x`JXjd>tmQle`Vbx#v}FtL;c zt5zN1-4BYp=Q77`!ft8PWh_yv-oX@ih^Fekmb$fdW`;BXbbVzXWxk>OZ8+fr#xZ2= zaz7t?3{%_Cb^f^wPU&}O0 z+=wx}3jx368f3`cdZ6aL)=m4BXKbhx^fH7ERLsWEBP)WVFrD(Jo(#!tPfU!m0vTD8 zT-aKpVobI}?av`CW{p~JL?gz)p@^8C%*B2^YN)bU`Gc_VPKMJs(+8gTa%AtB084Uj zlh_}JUc@!^LacychV_{NVIb|s8BCHhKIi82H(Rc}LTs;VS*1Gw@JsHU=pg?J z{Z>y`guQi|<6&_=FsI6D2R& zyb$~;+Z|cP)4TilEpDNyG|rTHhG;NNdA-S6XA85&bO{_55ut_lj5vc^#K+m_^mI~n zjRhH?O#bt(cb{lmANuIN8p0)QXqWXTDDECG*y@^CtBG||EE&hv@y#1k@BE&LD(D9a zHz)6qM<3k(bRPj*lGFIrV8CVWrhZ(}7djhdO?RAWte-2G)&6=>fbSoumr*%cT<+rI zg=7#`IpOiJww=tmp6RwM|JRE@se#Yk%f>h_p4sn!F(p;d-cqw_cs|IE)pI- zHP>4L8Xi9WXFfh>x48I(>IocL?hk4jpL2hVPi_#tmojy7Nvxsc1+N!{CqE8yp?!$+zcy+k1F=?arlTx8&@q3?4@B}vpjxgW-2AkfcuriTZhMUKTM-ox>viE;f=4C znfnVabk@;sIRQvO&u z)kdU6I$ts-v&cO|K3yEj%2Ky7Mn$7yB4f)v{@07_+GxuKiSsMx@_i+kzru_=qNk(4 zR(N9FM1wCA>da9>I#Sn^JQZyPHdNY^tF2(CzogZlNyfX2`(J!Ps2ESG;;x4#ydM}J zx7qwsao9hvAmd}?^8ZGe{*$K`4&z}HKAYF>$D60iIiz^Y^uJGg|B0l$;pc3^gDcv7 z6Kn6w4>8{g{(n|dJXb2~Py7nH8m}kj;aMr>f1L9WbhlFfH8%I3Xzl;eHpmRTs5|m$ z4ScN`aJ0<+U%5m6r=+D;Rkqad4%1u~T+`4HZKP(AGiM{rmC99YmlDGLU%Zw7rv&{U zR@%GJl}&iRJWVhJ4=8X!oc~|qdH!FBOI%B4{nv}p64K$i!0m$#{iN83$BcjVqcBD9 zhY^teZmJW1GNn41NHO8iZ*<)&vttxXi^LTV6-e)xS9r^Xv$T%ZVs1%T9UEa9Qju){ zqeY=4TdMlkv1l~N06*h6cRW*BIu-AM^w}{2v^MLDnTXkq>Rca=Qw~w&LvBCBy!z|K zfif_lmxAIlZFL20SJ&TC={m?qb5)b7R#!&x(Np~PxG>P;8H7A8)AXkD=dyD0c-lEG zpL<%a+CDBHI;jGRzJzjjD|t`9H?pr=Q6Iw27ZXXE*zZHJE2%f{N#Sg>_(YDIokS$~P5vqfZ|kE5+?!4k4Hq@>ob#c>%F*@QZUR*|+zX0}Vk{UGR8^xahyz3e8nk61xnV>Y-1ftUT%cA8O`LLc&E z;T7Q-#l&0C0!L#@ek;KgmX%m+nY-2hOEALcBa_)1Eq_`|lW?rW8!W5O?typ>mb`?{ zeaxONK7t!ayg!{qkj)*5NBPYny#amfrq7QY7Z2{~* zoY==%F)ZZ)$hSy2jJ0=$+Ew|dgz5375M%B!)Q!lq2@LK|3MRsh1A+=_MZqs3oJDq< zZ^<9=T7%o`NoJhu*>Z1-Jdl5J`RM;5K1$P}XWT_<_FiJZMDM~NEs06I=zrSJiW+5C zLf0+ABMdP*2z~zd-$o|=zb(_0ikAlka?d6b*E7W?&O#17u(l_#{_Vlrva-4e5xv?f z`J{v${M2k94Gk-|9m2Mc>>d!d*=9Ly7B5+RM&1JZ9r?o7F2}!DAJMz^I-eV;3eQ{> zdFa9ziGJGATv2b5Iai@pn%(Cc;~Vy0%e65y#~wv{fn2GUNl((YBwF~^_=W@BY`bhz zo_1zKX1N~6|9}7U+S@CkdBH$gEH-R4`$x>RHL zW?(%Kp)EqD&YCrM3l28jtDdxVVYhnT7(yz{?VR>3Y_{L|Z5jr~1zIo&I&6j5WSaaS z->PQ!U9S^5Vv&>s4xb<^ssCzHzm1H~lU_IT(6qs2f+iB-(>9DArxX;QIRvy}1tmy; zewj&D6@E$7kxP;5P%(+BneAgne=6eKec9FxNJ~}TYnR$Xw(dBzvEp0ob%t#qXOL07 zkQ1rS*NZ`VI4hYevOBQdQ2QoKTBsBX{h%?G%s!SG!z@#NPqRk}a=0lncfMjUC$tjW zh3EpipWB?tylcH1@dy$cuuYAPGzQb$r%b3>THWk?ymHGVS(9FeO0Dtzgpv#lAT?z0 zBdJ21G2ALu1`Bx73X?*D5cETJjAnWCj8dGYkZ+q^w!oe#SgoPkw>8<5Lzb;*Mb|9K zVkI8T*7pcgbeB+a|4*=>qQXRG`h}qmk9?FBtC*#lgX#?!oy84nV*M=5FX8ks25oy8c7*?sU$ZenR?!fTpva-+ ztBLqdah$N# z`{%$iV&ZMh832gmAySv)yc4DPXeE9d=|APE5vr=`iYh(11w+lVIUI`dhkWT;(r*bt z9~6;dWAPvS^ydUBu9mO*9yO9SC_j&(>k}>7l}V`?P@X{?9}>2?W#9}@w=?R%T2f$} z^tMK`DY7QT<^^+rKZ+KtQ7EaH(=oje4bEfYLP^f9L7)|NCmUi!5MmP_`hLZ94G0kocO zjvq7>G*md{Mj`!~YW9T_S_q2ISX`+?92g4{g6n88PZN*^S9yz%3ntrSlEB8RDE@mE zEZ%jgvD_LF{O40-CB;HV$MNDMTIjyjbAjK3-m>^Mk_I} z_ZIC^TH~m^Vr5rv@9ppZzMKi{MJ>`cYU{9)WL_2CnXp##&A(po-veAsq;=Cgg6$?c zw~qT81X;2@7@JhjVuqp$#^-xK%1;kg=_b)vp^5R_NIf)*PDNbfC9r$53+?I3o7(OR z{q@2SoCFvf8lI|?_>+B;fPemJyrqpMkFnxKFbh)p1vnFD*HyCoR9+7 z8jNn;k+kY&s90#IUgGGQKaDXz!Hv}HR5pv}Xtt=)@CK;AraPoK&SEc5a^7|5H`?mn z%Yp(%Z>lS^-2D`3JktH%uQ82@@g|H(NmIcnW3Rz*TwpLF>bdXa->sq*5R>SVgwn9X zrd#u!uiHXoqzF7`=e(yIA=aW5uI5)KZVm5nWDC-(yi(<&h*aY-xPHld>WIE#(-l9x zBvJQO`B%llnZo+CsZvyyAO)w0uN{+KXSz-$`D0 z|CG%YvwooAcw4H4AlO`-gOSwOtjW%bH}#lW{j-dEw>clJ7xe4{q`f765m6-2mCfHO z2L5!WEjX1~s+EeaS!65nV#8&;%(&lT8!hd;f1}^^|~ew%@-(_z)xJ60y=vX??3q{g=1Q{jgs*UBkp*SAB!YI zI@LT}FpG2hsP}b@LVzG{O+%a(awM&RO_|9*i z*}qp_~QND*Rd;sTw%(O^>C-bETbG~GQ zS$z}yQPX7B;Ge@Tg0sEQg4AG_xNmI{r~LPNVm76Y>89WMt3!bkS_{Y4P?Kkt^`?=t zlA&k^mKOcxo2xPqwMt8~MM&CG_9Lq)|TaJ*@>Rak^4 z9+KxUn02V;Pxs)DW&45^^+VVkOwLlz#ppL;x=}+TH&5g(TXLa!A^kj9*S#MM0Jd8G z;8bn}`q=10dZ=HO>inSEno?buDQ`VgHpHYA<=0S|?{A|qYF4x=%)nPvmu6z&ZE5q$ z8-h*&iqzRZ6|kxWE2O3yCU()I$Ku?jsmV##p1!l0!z?ugd4qwDMw9@RpUaU|b9G*U zRi3wyRGk8h=rlsF;+dmc^`SNzuw*n_;zX;J`RNsd#B-j-d5jtuWLF2K*6uQPqd5Xv zoc-S{Hc1vyePW~#AOqBuEOl(Aa_skOnNSmn!oq<;`~5|S>p&p={Tb(`(9wEc=0G+EdSkPOcX03 zKmn9&ho_V8+&Bx9G-mEJVjEpixf3Pix^KJ<_xUGjxE@RgOMT6iN~odUjT&xC-ZUEQ znqp~lG!;1+nn!qZpG5~i&uhEV@(VqzmdOTZ~l5=_yk&~XpQiqzcoJEm#SQgUs z@xjiTAS<`tio(!tFrO9s^&K+df_W>+!lb<;wIEC|L$#9b&{nLc3|p(&6Ss{UzjY6W zinw;*j<2{gdvyIL_&Cw(KU&?Q*i8)}7uNhO^!HuYL^YHwdWNwx#B~eFQXr5%!*}ty zwFIfQ^56EHnWP(BsFar{K`8SJt1uzWW!?!5&*!u0@NdOPP}zt+cjz{<*V97>F=?C! z=93vRlzYdD2*K$2Z3hVbLbKoF!K1`{<6QBv)RY%Cz#9wUMd@8!Y^i%{iuEB=Ns?hI1xEyZ$St(jN$5fB_K zTEh_8WIB9yx-ItPOgGY8fgKg2VuRc4nu+Bstk2s=E3Te05PrT+<|GE9a#9_9w@|xR z0vMzPl4l0{ux&qp^iag|ANVXq0cRc9ggLJOAN;TBT4 z`)|iAjT(*tY;4~oMF15lKM(wnX@*-6WJVP3AK_@2l%w&iWn5t?2Kb&FCEp#qsn_^oDYqNqdt1}8 zEG=31rhocsT++MbXJ8i8d~NC*^4zX+&}#QfnZelozQ3W_u-Q6AkdZQ7=Q}h{{E}wQ zXfgRKp{K1Z5f3ts`?narE>b8pW-c{AVGcKS^Rp~Drt1B-Fg0kF36QXj+5Z)5-&lI% zyi)11Mks`bUaUcX>T5;!mzXa$P_aq8<0jDveb{cgV(<3s7gRM#_14-xpZ5q=;et3R zbYya{9S}dmSZc_90e$Q?N?+%qDK98U`!e1}bQx!}9CJ&igF>XKS~k~y*g7-C7?W8< zgjv*WJ!&Md_OBPv*e5A5E~_O14n~aH2GtvCIBqnLV(t^6Z0rw%`}Wj-7Z3ddUi>yB zm;|_skePXP7k@0V=+!FmhJF)4LsiqBl$K7oY*>2ybDUqDxyA8u-&YDsF|_o@lf(7v zrceu2F?iFVp8p-LQ7`t2 z;EoPKw`gt59`?N`iLFs{soa>n_<08NByfIic>CVus>}F8rH4N|%iacM9Fa@9w$_kj zXmnnjf(-mA%0XCw<%Q!s1=Z>+MaB#&o4*PL>czd{|(*3UZX0 z&b1jy2hOB`NtGh#Ld+_VJo5&D)p*lS+^U6`2uqM3l{jeAt5j!&HS9G}W(OQ-_i250 zD<@Et*pEP_c@OW z%{Cx&EOjQhxaa2%U32`Y?3G(m9Dr~(FBdchB(_V=r#vn` zbhqT03FL$W&B)JXu#`4v!^o7 zkd=~_qSc3y>&0KnjEVqx^>EQ8W{{QT0P8>$wOE773?*t~WfsUEzogWX3%`?!*F2wm zqMAwnJG_gzP5By#?}%nhqTzu-0swfh3B6ZzX!?F0L>;>Isge5qc;(9)(eJuZDbk?A zed~7`ao;2;{yDe3k%l{_T2ON|%TNi=`brfabH$s6el1z$b2Po}r z7oR7g%4ddn&c7r%>jX!lstIw)mDcxEY1xz+0x$m${iv)wAj&{;BYb#qxT5;6(Obf~ zDp>`0P(8&Dyd$uxpxwQ!k~CC*jBb{2m7Rmb>+fVTsH&Zob??EVF8(8R;lu*+z=xcJ z35&EcNYA?3+4m%KxEV8xke2V8hIPXi%K{+lK>g>@^Z|f834@W~!*~g|gq3_LAA|hC z&ZS(z&&N#4;;B@s+WcwK1llV%pL`ATfRR`&8|B#f@x5rpxO-tS_5brO;f$~0o*26Ms> zDEZU#=fHgp87K7jRKZswag_s-R9%7%U-sIEfsjV)#vt9@^drB#*X2#g20{eE>S*Ro zB}J2P470-92oZYD1yS>_#odbH$?+n&X9*qR;jVu>D&Ik$d7TKL{D;1oiNI8~!Wj-~ zsa<4q*|O9kcn&lB(5%&8FX|>E|K+b~zGdul1`3W1bx_Y6UOTld`vP~pg{Yes^#B$> zyz#zI1aC{qIb+(hA#h~4A6gN1Wn{KwfG4GAKaB`9=o7=@fm<7OJZpRt!YWs z2E%i8q03tOPSu9^!6;kRRBs?BMCUwasWhOR8a_m{P3p!I`7-g5p~KRkvV&W9zzd^05X@VSO57d)f~-kz}81uaO}RO*vs>Xo>mX zsJC2&qjni)w^0a-Mi_IX*|t8va#37O0{ry?kKYr6{~U-8?FprqHmCfd5sk+c51D5j zsv}FbWgYxfvfTg0ty>k0;F(a;#*z{!8J_TDlouC7}bB!mzk!3%eH_h7-Hppe2nxE4@236S9K?phGsosi&egLbqP_``*kh;$8$1+>Nu%J@WzIAcq)N*#o>JLNEUe<-qRd+x}{a zfhRhR@7);FSq7;X_KZ{qxC_wC^^0pqL{q1jQEYr}-NytB-a*yRh^>v2SFMs!r*iUn zu==Ky3iH7F+rsys`U*cyj}g3RXo(FPLs28ZBm?+7wGBF|FjA7!U7=9u(Ul)CB~gXKHV`@4LYbp9?Xw~AnD)~E+^Q0+F> z+&cmftZX}-vz;f+`Hkd}O7A6QNPZ{p#W%SaY!aDDd7dz}1HFV)80Q=wb!u5gIvrE|-R##vaov9lYau#OGmTF;0iEGKdo7&_s&aE$afAc6vmrOJrgSb$nl6=ox)>CoXxD)rfm5o-j~jDm!d8lYozW>f0s}wEKYK1hSwc64!N2z8u{7ra<}u`tSct zl6wPbqT2}R@ryJ}0BM#%;@?8I3yq_z0qd>9nX|_p?#j$VL9j65QYW=w~ z=9e)@7YcKudzAtlZ(4xN%>}I>smt4fZ@>=sB}{4`d*3x4W^y7U|C)r4N#lwW;kl_= zb3m6zJL~U9BbgqXUq(-V6{^3jz#A)&!DQ1}m7f=r=fJxNF|kr9VA^Goj{k8Cz{gIE znL;Ait}#cH9DRjXZpbm<`GttCFkiyU`luUM(nZCaG-@5(vB`UMOawEVb<#LvX%Y#4 z#>2wEY&oj}7@xTvedba)Xe(KKpjK*AsejhFH*h)CRjX_m!2)yFOf7P!Oy}Snm-k0L zBYX($@Uq*h1Q{j`scZHe%lT+)YO~$1MW6j}7UwVd8Ud*bkG9}SBp>I$<5X^bV=}GH zjI>H2N#eGY)!2p2HZl@{6Pbir`FqCIK75$^MZCp`3OuHO)*Dj(H<=p73o8_TWedx98FL>L6{yD4p3jm=^ION z!3Gr^~6XPZv8yKmtlYuH#+qz=lv#wsDjV34X}6Yrg-3(K^T;b%Qi z@SNM0eCjek3!p|}`*)$Xx4L$t!l}4G#-(>`oCav4?3%|S`V5B>p&4|VlT7R~0c)|b zTb`OOYPxprVbWP!vQzO`1b=&48daNNLnTe6SFT87oh4BPj*qs-G~tE3e#HvUmYbYL zs1J>p;lZm=_2p$tYuko>a+l?}Rd+6kF}qSWJaN87P|7^wdpX?J5hLb8xD4OIlB1vX zL*4sbz5bq%Y3q+q>oQEov7T~#As1yck~Pzu@Ms6KF;jD-Iy@!8q1EgW!ODtc-0y1c ztaKP2VNePy0V)RUnDNW_KrXYBPJ!|O?7d@dU+)04BJsM%Vt}O$Rc8P)Kqfw-Pv9Zr zm=oT+o>Oh4>7h$-fTy#;Akc2Y(%w8dfdfcVhXzUn{Po7eih7+X7&xA0Izf~CR~5Pq z?N6LB%Wp+{ewWuZW;2s#!9~oW>Ah)*7tRMsN&bYTBb@qfeG0> zWY`%TSzLRrwW7;t$y48Bsl+eiwqmM)4Dbb%mEGSv1xU^4-4j}2QQ_0Jb_M*IK!{_@ z{qbR%jY#mi$r_4%<41Cq43ha0BcL-N|HQvYl<|SO(oSzA#gSOAW9t8mU@Gb{l2N$zC$|dya7idm=(r}f^<$K+7StUF zi16=z>NL}g5)kcqzSGbo%~Likmu)BETRzHs-@Gq=nkmod!)%kT=856C~fd z_ZN~jYUO;7ALz~z|d zh*77!SnUr@P+@em(<2$erFh3c5 z6x__SC1E!BAh&{0?%d~%iEAZ^#z84>b!t3zMZM z5gYAdc7`egd+vPFVKlFy{Ik8$1Mf|CgDOUSU>}up>qSiX`vFO#f6Y9;PwgKooW>gX zn{%OZvg{@Vfo0&WgckPppnFL;Rg&isrGe9?ld-|8Ww#;hgZCo(zv)k8L6%xab}yt>aaA9 zPmszNe)qZ4HRr%-eEbD+rW<`fYOwblarjN_*ciLus8T1Q+KMja16rCeZR4m#Qsv^Z z{=M#XO%uIvTx_+sDqi*0H?W&pDacO?r(7nQpUc9vw_f$XHmi`3Hnx3LAq|I?**NyH zPnfv6v3{1GFfKqDo_Ks|LYaUE@0)FYm+0kbUP^DQS)L|&R0=RL+xx7#VqatC#-|EP z)kpybX1!1ZU{9!!cS#)wO=x%|loHUYx}+L5z2wZN<9f(AQUmJDPOm?A z@7cAQfu=ea(EaQhLqM1wYF?ExOmoM;qO+#oARkaNyTdUoVe0*^32RhbeP94<3I;Ag znqgx3s!-B?)I}W4k!5>DB%)VPol-Q*%U?)CavN`>?)sYI*Z0m^g4A4%#iuVUgV(IE zRWud2H_DjY>^aAjo47+P^@s<~gIQo@j$TT?kTe>SiDklt;_JLACg**BLq>9M>%NtL zx#%lUa|@6YF0}7pbIN|-;P6oTGxCHHtXeXYJ;jfoLN{>z5(|*Af8|`=A;Fc%2!fip zJ+$`6)$vBLLh<d2Nv^*?~64$L1bpC!ZE9GE=WDN5do)iQZXY19? zIA15|y}cg{6>oU`MKNp%;w{h`7++NP#5Ia_E!8t@`gxQ6=HtpBH?*kog2Q1vcoOe~ zXDa+NZiB&;CjH~Yj<=NCso90PO`*g^=$wc^bz88a_uAfc;|-`ojImXPPRgrZlUcN` zTFJS-sDgAS^#|*Ve|;gz73?pW%MTLHCWhokm6R=0T&#{fQK={Z-jx!SvwsJdS2g!? zV#1h+t}ptkvXgYzz0fo-6|N7WUTB!d3J!G%CPVYYY-H7xS?yuMNEgntR{hUaM1|Qfw*d6_;H6Ooh-bpMz3Gqd}YiQw>yQ zsnxL~q*(={J%<^)SDdA$Fv}h=}$lgag!`D*pJ4jZTdf)3-Wkr!NxIE3litB3J@1zdcUI0*OYX zPAaVi30|%hw&wUwlMUng8$i-liO(#gE)=>`r}eF`M<=};^K_4L|1CZlcWYKsc4q!; z)Lw_|InzY4#*#;E4*!~WF^Fuw;Nd7#-!kXZBlvDH6vm(tWK|db`ppwI1azf4hCInm z6msx_u2H3P_;yx3lrSST+lmvpvP_$85gI}{-veIU>U?chLO|W-nFX2+4Of3WPL&cG zJ5$CIA*!lBuxfmQF}obl$)Yi3KH+0s(Y?xal+_j2XYmvGPeJFQtI0Ol1acgUvBSWR z;uA(LB-~fwMNX9|1XP`8KE+q#_4fdXq`)H}z)!RyU6-M?+pcV+qspk!g*{L`KVnh$-}K zdx@!MB>HyLBtVMOXyJ+;e)NzS*x(#1>9JzS z%>chKF_QH)7DkB5Ze0!d8Fl&Uk&+$3W?B+O-LUJum_U-QXjA_*k$WX$@5;N;!^^0o|3sHXNq_2$mqW<)clfsatw-yE0kQ$C>=^@u#S95{13KW@Z$Py1O~ zyob|^V1!1dm2icc+7$088?|RY*%>z`<`)v4oW1yzD&ddMY(ws7I9B!3s$XVB$6ONA zXS4UFuX#DUy=hpnOxIuOj{Ia`HEKzEK==k9#G}Hy0@l>5m!$>IXd9t-zJr+nM2*x# zYgG$E`)6UUcQ`_a0Dp}%i7L(Gkj^cq_K~T^Gdx>`T=E`LnzZ>xqR8*=RBV|RKeHkA zgYyfTC76|neflE{;(hl3ZPeeM*=y&ZUG!+$3AW()%g*RJbXs7uJCzA%+v%(O(ndsF zmo=w$yn_kV{XzzPOKPWSwaAErQfMf7)th%f<<_=3Rpyg4x|lc zAwsn>C}$gs;$kji4b>n+&{;l zj}{_sDG{ID`ZUh1^ZlpJrdJ>5GRwUy(6X}iva(e9-|?eKi57g}UDP;vOSpa=;p5xN2#=*fm+gvvx?*2;+xX!yC`6_}RCV+h zlHzH7rO35?`e{9z+N`lzMlyqvOyO6I(M5z#CQzN9nq7L`DPy-c$hzZ=O9v3{F?Irj z9DEiP{#Nw#t1C;3kM?$@ke&XdNKW9zf;_xgEPi(6J(W^-`_pJiT&1=FhKZS2B=eKX ztB&Jy^^F>$xBr|1{KK>%`Us?GZ4{;#sA7ODKG}fRTleX{K7UQ(^QJ6zE9V23;?Jf@ z_7Z?bTvsdU82-xlPc6^BiMnBSTu(i>EheE-H$DhmvJ*0NG*(=u2qSlbrlh>DkjL0yclggLlwcJhEfaQEyqOt^!c1<9rvv!>bGj+YLC{O_EyJ2dQ{ie@9nrCChkKboJv zW8{2q%-@m9uaxd^O#S+~c@FyBA>A~wzL)x?KQE>~Q+M<0>Tz6MV-j`2&=Z>qX`2^j z{95W=o9lrm!HZd7=*DbTbnvI? zgF76GcJHS#8E4Y4#@mXt@82)0*yS>27c>0T$Iw04 zUXr~b5UL>MAJ^Qk^M=AD0Pc+D7SBRh+}c<_hp2QelhO3N!|fD(a?9~JpT=Qv`t(X# zDMuP0&z&zvCne5VwJ)oUfk76w#W4uLK|n<{7ICxL)sG$VWj7iJg&b<>Ft*{tF5B%b z=(@5rWgW+9l9?X5S$emn=A_xF0+2UPSyiX+-@_s zty~wSJ#A&mu^gWwu2Di*TjaEpdg2mNHxDA@+7Z3mG&318a}RF7a44*->0KlXYOw7L z9)?DFbcbcqwZfJ*cc5iS${I(Vdeu2;;rMt*Xl>e@{%~EwAS(SA>^_b`9F;Dd@?1V3 zA~v52g8@Rg_aa!GX+ngz0&x<+Fw#d)I>ZGayTMN=;!y>Bikc?G@+u$2E=Z*KSsxxo z1dBBaml7EiIUwB8`S4p&6ikk+txk=Vc*!;E_^YIFyZAE(j`I0zsHA-P4NJwo?R}n* z*@}eEXl!fLNmlT*Au1C?squ5=R%Eyi6v32#LDw{?T;nrM01OP>?^ni~)%wv>RxQgk z5RE{5^Xfy!%odJdHQo>@t?WBS9ZA70PTf&WUVS5QeKi_IpxGE+p>ECpJ!hPJcGT$_DiCmxc{L#23(oYRc}WXzx_q zye&p837&XnBSud8H0e%CUx(7eJjyczb?WBGFIi*Q>v3_hMMwPAZNV@I!^S{BH+stx z>y%Bk=ai+zNO`;nbp)qCuEN5c(HQEpR1yxXBnY-#s&&aWB%ZJMZ*q216Z=hOdxaR~5V-Jpf#JDQzGRg4MC9!&9 zFB-^5#3qc8-msmKE{qrA@selw?C-wp=@8j2J*)V6a5dc=g2>nIJSqOhXp;xe0Bxa8 zOof$bNI0&Dv$k_G!$f;>7E)1u2o~-a!`(eJzzXw9hd5)GcC9d5BjeRta3`!fW2)tv4IY_&TF`H&;_JBL}nn=?F-k^Dg~oW;?Cg zaohJvKOvjVl>ZNc)!5gycjO1Gx)P2cQ+YC@XEy!cJI@9u1cYi{cspx%1Vz zCnLf)Fm+Y^zhi;jLsK&VOEM87K^WTE#?Xd~U68YL317$iobC$TXYx;&-qNEF_cPpn zNyJ}m`S}(CQGgjTpRJ0#JTl((WMUXzik1YX5A32qKjUW9^9sx32k8IqS^2*-=Kth^&Bvd*0=d+e2GRP%?9?JjbJneEu=mhCDZ)~qh10{nB+YJbL$CMkwD>D zI6qFv8nEI=?U$Ks!inXI#BG(bG?sH$kL-u82P&1^4g*iJM-lZD_cB-r#!sPgPkFmh zPBZz7TJy5%MdC8_?7S@3IX}j)J&Y06XM85zEjU-xS)3dzAxdr9Iv<(5oJdo%pnEG2 zZ>a!k3z(qPO5BLeZJ&q5MaBb^LeEtPB*@z4v0JjZLW%DL0s}L_nOL8(j7xY~l3WF7Cf?r3TpT27HKTW2 zbDC6(e?jNJfpB#lr{Tb3geGrWo{Pyn3x8H}6T)GSCM^d{iAU4=5N9o7yLP{;Sp5|l zC3>~J^01$*3_}}S)YR%rM`PAFV$3yzv3s`FCOQ7OuRp(ew7cR10##j%tzs{O*yXN5 zS8f>0F9IDxA98Vc5g>+{qIL*s0NEa1*~+5s9M?Fr#)p>l` zQkK=J(_5N|3Xl62Yvt-LX=R}C@Wh{yFX)h#+RIuVTjz3W9z^gaBi)ZYo~W^0Af}YU zOYNn5%DWQKR3#ii_H!y{k&y4m*u8|Ww!nx51hHP=q?hH~+9lz5bqp3)e% z!JPlKz2FbbruwT9g~Z@H6n#67Q0IMj0s?v~+PYglv4D;5MldJ(azsLPKIs`BGaagl z!iY97<>PS}!=8ciSfz%dUZ445gMo%oxlB-e`{Vt~z7Oe}j9{Z+z}X`oBOkiQL8_>y zs}%hF%f%wp6QQb>tLUrhow;;T9~Uu($nCQi#iJN3+FQF49{1=Zjlqru(sJCsHkqG# zEM9=Q6FuuM7YDe*^O=0f)xX)CBF>2%pE0W@j><-oS~l6(zC|72GW-Cz%f$+EiQd;S zCdBgw>_rrMk~_v~=_9&3Xg>6NORF6Ve1Ah|!HX9=&cJGr7DU3UIfMRsp=p)RO1wvI zBW9$pm5iNc zhUEf&p5kqeQU~Au_u46(Dw?r5Q6x$uy6kEq>)$LdGYO43*egcezp+R0e84+{F=i2^ z9DU6i9}+V%q$XfcWH~(X$4=n14PSMT`?t4{jUFQS)CqnY{#LPpO6t8g zd)8S};u|+)bS;J?!nk=OcL7T(HlFMR%3_szMrU=ZI?S*Ar}SRWq>sk7plZfh=Ar8! zG{7!_EJb^i+s>l#G%RSz|;5dJM-7yy(>lv8x=RS(Bx+34-=eD^!-`-HV@k z(iY#4KGaPF5_~rrXPJ(K@u*gehQmRK?e(OToN*76nW%P+SqsB#>i+JJz{)5}mf#T; zy^37$lc_^1WwGKd?zw_YsT|AYGph?N?*dV>eR6g4$KCTm;Ifar+s|ao8>ew2$>nkf zJe5Psi=s2n)6e2qO~`M2lNbVopiOJDnr*9b3x!mTr!xLC8H-g;kE3T#^L`<%%PHgStd2lgo@4F%_E>dTX7`*ka0SRw+F4e&SG|vF@w!Z8WO7dQiOM2ZFj#JNX0kIS0Ippw_$5$!AD5jEm>4rgL zdAlbd7taKmi7hZsF&($a$V)&^uc0X z=btR&x_;fy4%5kX{j^P!WUs5ftgR}sz!2HK)J_WMnwNUf> zC&}5BX*}b#vD(x1FvD-wW$0cycsMXS05%#xs5kviQC*+ASN&Il zUeDa`Sj1u7gbo7KBDZt4w1yS@ z8YWzq+<9?m$fwZ_M38PbgO-}>sHDP%r)x4_ba1cmY2GzbH(|GB4bT5&aEJXEM@j|d zqeyMhJwSyZWQ_TKwV&Ta1G%qpq}EE0-;B5ML)Dkqi%cOC-%z}&^4-hFsPh>wp`#1> zz%G!4u9?+>zBwF1w8W~8p?7X>EkEVX4afYZoYkgq+d-AqvQx>?rWDOP#f9r0o7*db z5L|Zf+^AN2*v98$eE{5T1F{Bv!_Cc38NMfSEA*35I`ygv!j0KncL_dVj=dPs^I&OJ ze#Lffrrp<1Q^}faGO>mC1P%4d!Gc?-Pgavd z4C*maf!I!V6vLF_`EMT+L@Q-p0I@2?ApGr=Shg-ztNp6oT7kI}3r}5tb{iiJ#Ms=FP)~r?43((K zDmvxNJxbDaOlZi#~B55Lr;YkmcAj z_UPvj!o1Tgs-1rWObM)7DK9a7D7pYweJ41M8`9WiTEM$>9qwQSn%GG)7O}n^Z` zNSmrGvSP9wbdm-HZ%;={Gwe7PGk}_1>^LyY2>oz5So6l3lXabf&i`Qa|EebCzdPA( zWIZEO6<~WU`LsbD_n{(vLr9Xn?8Soz>YZ9x{8k8}@inFR zN4Qz9#+`zfz4;N&CGZ@+Cn?7NgL9Ka*Y#uK#u6}Cd7=T&kgUXlOk^<_%1V6qBc5pb2Vl{zx0*8HmWRMCZlxr!fycxIoL zU(ki@Y+;&|L>~2)k)J~ubBD@^#)KP{ye+~DB(%+rSdOkI+`DzbU@b+*_C5T!mT;2S z+C5ePeu|F-yp|C0&TC)w_^zMi#ivsV*o4r zuLDVw?SPt)9k$W5+U+x-DYTz}d6OV5mPb)&w=8Ocmnz|7h>S7;FiVtDQKs4HnP|3` z0gv12Uf`gA} zhrFm&_E#@EHWX;DD{uYo^ZA0%^II)5-cKQ&Rb&+_x)s~yIuHR>t@l<^D>$X>Em{|E zl{k0%HQnV=ZNyTWUC!1N05)m!j5b5C&DEke3pd&SNHHBBWkaRV6wAOdNFhQt$|UXn z9@a;`2`eYxbmFe&!G7E-yS)t;xfEsvV% zi6280JBxO?n}+KnM5b6%1UX@b!LQ9$@GP@RV2u?!>|QeW%K@Q2%?^oo@1i|}KPG&# zAiwa9(72NKN^x)94x70c|)gq&);T#*~vljX&nSOHD% z8PEynPo%YmK5&*M)!jB)Nf`KS%h-%!f72u-@l5IrAP$kBt4~4q>aephQ$NiU=WJ5` zJk1Mbc?#k2|MC5!Lg3(0s3kpYHkHekghb2NN`}`?C~Zx+?joh({IU}cjkbk~!=DrA z*KCINEP0`P9-?1>n<(?)ws~r@d~f-rKhj zX_kEAR}?G+-CYS=sjCgWewI%7<%^Ew_n=W%N>?~1;p`eJ?(xl$(5qBloBo}Pg&DjS zN@ZcPB{|obIZ{#Cyz>8ZfuZ!W`KZ2=kCB;MM9Z+k&L{iCu1n4*Zd02Io(S3D%``u+ zdz-#lrj!k6{9%5oEfum>y-Lv9*c^}oWrmT!mp6`8!vbY>Ps;YvAe~m(0(+ z{f^O+(oBMvkmx9QOsO+%S(N4GQnO8K*&XTR{T42d?J`ia{=g)%6l9{;&E4zRvPHv> zb23|`h=>a+3I#1zch zS6Q$Df^c2B@w*N72^%ZN=C1`f&Fm>edjOU&7+#!yh#{X63ma%2xju7OcaTLLLkU2A z(vw@ij@PgE73({tOx+_aN%qu%VV68v^e}=vCR7CgbFwow_MeFFdtmWNn}9(a{Ti!M zp+j2>dQy{Rid8F!D@iM;!zd3I>}ix)rI6^9LO(6Ax)MCRTo0^YWlS3`ms+b6`v5X9CY zrvNd`I~!Y=dEzX|9vp31W;2HYZC_Q!s7d#v$n@jna3W3c59CqI|7os0LyAs<$PhKs zhAS#AKdy~Z)qdj4n^j#P0`$C(U#+Uv3duLdr`BS2I_oyDzU*lxvqLSx!HXti=~pSU zBD3)%NwYP!D-Nc2!j84tCssa%uvxsZXYJeRWjWWDd+G71Z68%d(yjk4=}+{2bGx4< zWDIsuq%;4<8TqLZ1Jx&sNueGG6X{ZiNDPN>ECb`&5=#}@<-#zYs<88mIeiUDA*Rfn zi2p}FOAx*q>KPeHVW!bXQ)*8*3}YxE!>ZkKD#KX9wO_Q?;2_%+Sdr@UE*!3nFC?2< zIA(`;NzGsaM+HgEir0X$iW9(SK;tlQHh2rbcr;kT!Su~A)g|UfodEZxqP|f#Qk6g- zo@Aw#a;^Lp3JOAegY0qLA09*Xm_#QTN6BxjGKr`Frw~W&sC9btym^U}Hm7$xXQni1 zdS{v2EsXWj;kS+}U*bSjtDtL8)6(e-hrsnbif!q#q^8_7DcAFjONOUXk%QzOf4vhj_d>cdT6(o%C!alOWACqAYj#m4rm8tehI9F#v{ zg%7goUT5o8^YcE>tK@S3B%`QoOM;gmg*_q;>r70-;y?D5*NspbO4F>(H^18>H#03V z1Tu~5Y3ErrH#VMyIK8(`6?_*m24Xzf8E4JI6@7gEWR(;~DWc73XUeEp(V)r2)Zdr> zT&XsdY*}^UcIl_)A2{f}eU4urFWj}NUma~upR18>0q=}=%h=9Mv2e;Bt^Ixd%b#dG z4ne<=VvF!)>>;L5icl}>>F?Tvic|%t94>FqXU%OPpo%kE4jXKbAgVXD`8jDszmSwd zk?Wt5mI`8<59^&(a}~>8@!>i61e0R9 z1G(QlD|U{K#2GuC3VRc#E=VXja{C6Kk5T(}vKtxEKDVjyKBm0HKaO8 zQQLK#Nh)8@qTHYR@drq36y`qJ*LeaG6q{bo@LQ)wCSoi@dIth;y26;8=|wnbonif^ zg-Nf&T=6Q?Ld?FsRSeAKp=gJsKIF4rD?oCgZ#5oCv`#bZcXi~JBXpAraX16o(3*Ey z$)HLa25$v7u6s~M$A`ur70Q$xsh$TmP4b^FLPDOrKbO0vFEj#Q^YTw!eFDni@jN>J zieHcDJGJlVOcCChX1z?ws>8C6L!Oq_d2@eRa`CbBXtq_*cjp`7$HbP`rz~l)|ARf~ z_=X7GcTzE+j18c*4>2N=xXL{prUZv1S&L6?3EZc4E4}!{PDu3C3uhDK8w2g_4Bql9 zsvl%_!duXE5mlKKawmHJgl45+_DGws)GrsmkhsjvlnB^`!+fu<`a-ZGD#qDdLSB~< zMraId$taOorb`c%c>6dZ?z`x(u@Nbt7Y;sK)2*npRTV0<3wcqo{*{8qT1}+D3JxFX zY*8~GY9O2DJObO*`Ix+y9lMxaVKx3#oL@n8LzB_wu}SPBlvp*?G}_pfV?_MzFlrJ% zO1!7UT`XboHw$o%e+gdt)t$Y0YO#Nfy$4*Tr7C`rlMXt%1^s@5uS> zv)98xRg&{2o}}O=3we^awBEQ}a+|wO#&z%}Y2ef)o(K z^zHy!~2Iko0yg6;)Pm4l#{KwxJtv4m}!(`%I_K?`7~G+cAH zU_gbBy~l|cj*KUSBH+Aen${xSJV0CS7{|yem1y1V3N|x8%Ijv~|IFG)<87WYsbb+? zO6!?O^PjH@;oJx99hkb-U1-;ufgy^%ObiBvThHD(YZ71dFj!kjU^INu_L@=`YZ`c; zmXHcx29%8y)&HTh-^C-!Zpo2}o-``@&tX$MHes$5o5Wr?mDrOhh2Do~DR~gyB-Xx^ z;%`k9Rg+OGB})#+!YKaQ!J?r2bQ!!8ai4ypXU0$1u-DHn>#G-z85!LY)H6#0_l)XR zl7G(J*_=alP=Z>F(}mm{!gX+3n2Ze)9r6{`YHGm+>aIZmMRYQm`sP(dLkA+Qr12?;t|@V8TZ|N8R$t zQ!%Y!S$l?0TSN`u=;Mdeci$^Dyr1MtfXPmtycXD!t!#UqYDfNCP_dAPPcuk%@5p~JNj(wad}OK|!+l&q4?fjB(a3#)&Q>aki) zD8*Jx^juhQ#=Yi~b2-;gW^lucz6)k|hG*qTUHM2~%6`jG9M`l(G{@^yZDLCb7LriZ zEju!qAwTAgrU@PBLE+F`WYLw7oz7>G$T{%K$gGy~_~5c2%gd~=0arFTE-zLV3VfNS z8Nh}qsLI)!7~;*=htsZ;zTF~mIp`XJo1XwNZJfU9f$2*V`=I`y$G|w1Np-)fPwml; zNihdwEt_8uXMyjfljBqbM?pqbBsij>VbMi+7b;$uj43OkOb35;&9^d^MsL^_Y!}NI z`94HguW1Y^_O$g$RzBs(nBklr^w>3#kbN#Q{z$F4LTbAHcIv{<82D83Ju>s+!UYQz zJz-*>ZFmD>jOV-GcHP-g8YtQ!-gJdyb1dLQ(^MchDxjPjH<586ZbNdf#kG>phKq0WhU5RuVni;5#X3-N-x{ zE2jl?fPdk^3)8lCcHtKHePF}!!}Iau9l#5S$oOHF}} zQmnB+O~Y1WNL7+mRX8Qv7H0T4*e7M5=Vq8FJj!O1e`<&Zz zrx0WZ(A_+r^zPN_r|;VRDYzVFOBMKWRU0}618nh3Z^@N_S@ z&nj5kUD58Vr}qcT$Td8u5#!W^2~Havj9e2{AFQR&Oi51+5hc9VDw7C!;! z5C_0!;$C_$gXd&rp?feRton`j>L;*L#%1MlA!#m)8gsj0$q}5a;eNf-jJ?gDw6%6y zp?f)KJ{a0_uZE`}I%KS6jT&q9$62CwD>yn$DAX3L8u_?f)=P7KsS9gNm$8=p4~~7s z31=(vvAH}0{-IfE8PL6{kWIvV1lg&n`0LtUZqJeA8dc12rrF?OQH-vztlk`@t7{c6 zjT}p|`N~&jWs^~Te)q#nlkaWmo1HJ1v3I}62t{=w_O#JfqOMPDkE*eBfTAQVf^E=m zto0YtczS*x4MaGe5$ROTvG}fVIuZJ$FLd_6zKt-u%l=$$Sl@H0T19v6!H2GSKPv31 zyt_0KuPtM0iTGfsCi`B2*su0j82~1T@Ae$d0F4!t#$b3wqwY~CIzyJC5K(aCq+16T zZh^uaWnRHw2N)G#4PAN)&);@#O2$2irs%M?In>&kgtu0-d%mEP<8RaUu4(oozuR%p=>nTBD==n+Vj`)MKaM|AYjxF)7)Vuf(0BWEsK zNN)o=NMG1SOTxZfGLy5m*D>yDMy=5CkHe0UiIy{MAi+4#Jhge?F?zPLXn{1kRQUuu zb)&0V;Lno({*7ch*vC85lJelLz}`&l6@n=XnD9>(91zsok zwU4OP>kZKwl%sS&KR=Lfg2YfI>a%aWY%R*9Z_%Ii38vw5=4DD~9ER>LzC-}J@e=BuJ`-O1LO@El7eQt&(^Tjo48me%S6`UK zOJb5PUBcjB>}{>2sqnj^h)DTTH(B;WHxIvH2F|*DZdgWqVnMUesw-*GLaQiYUxWG zVwd}JSRp4Fq!N}~ZiU93My?rY=G~L)8nN}xhKcP`pEBtv>cv0`gSiHMc}X#T{M#%j z4ST0DBss)+hH5(YPepG4Oc-CxtX{mst+m1$?|xrqAvHWqbfT;vUMtCqDY;RpZUtH4 z0lkO@YSIS3MZf+up;^_se-Inut8lI~N$}ciV#~O*)XPPhBBM5SweW(S{Z3N`Ej!Wm z2e3a5!S*>R71KTp6OHh^$XV+~^R(_Ubd4ISZ8!uyr*%~tJ!K;lD-)IfPrw!_LfW?i z$q;gr6ao0v8Boqtqt;B)*+23!owI+^)U2Y&d?69RkVL2ArV^2kR=Vfg(XiD<=$1B` zxwr5(Re_IgV!@?0rm8aQr4u%@s6uTqrv=6l6u{3#Obb@K$<@t&z1?K?RpCkoHCEUx zV#F*#BYeT8P6wG`Umcj(uFmGj%9nMLjV7F#4${15#Q4y_7VRJn{ChCEI{5iYrn8f_6zL0Ki0alFziMeyWE0qiaQe=_aU!560z&0bjs z4kU;V&MKo!cQr7pJ;p+?AgdAxt3qLT(_Q$+jpPcE>{;j-G#@bi>&Mx4D7a@U8_Y^b zL9@lO(L3+El~t0f6jf=Yoho0ynqimB+gsr+Q!-eA*eT`@*7Ee1{;<6IYy44Lem+jr z*l)bA={Aw$tr;VxA=IRr(Net={DBgR0=hV1^hxa7ecLi4Q>!|Q5yvmiIanTDExg(h zr;Dn+Uzre=DMzS<(L8=kKSj68Y$9f}wPqka(T!#?^?j4NVZS7)zc$|@WlV#j5BpS+AA+6P31=|obbZKckK|E#&iE<@B zgbE}WX04xr-lxolQ3^1apgcyE_--a8%E|SRwA7R>KL6bBtS8XZ$n+;8@&Aa6MCQQ4 z+F#?bdssp+`qPRXuMO1x59Z!7I+A5c6BIKuV~UxXnVFfHnVFfHnOP-PiCHCPh7x0m zRaJNM-uvF0*FD?4^JivOMmmnKeVYB-r%5Fh z8}~_gPo1xcl3{P0Z4o|!I$pxJ1f8gD^PuWl(fkZ|{_xrhn(fddNcpys<^Fi0Z29oA zONLgKc7vW|x(<-Jc?uzp^!0gDQwRIQ0@$8Cg1x@}cpb990F5pbT!`ybTVH76#nHi` z7v3Aa=RuE|ELKO!cA`(Em+^o9v`Vwqo@q^u8QoPa=num45@f&6R}rr-PKCe7K3t%2_lA_+MwP$NdSPQ>s8`iuu9I+{xUyicecw?>O8{FpY?dBulC z(z&R(pfY4An(vn%ZHA*VgO+GmoF@56T|vVi+BCJs_EI1 zn!{&a$!{*R-sDmDl=8r#VEkWe)`qS5Ki~BN+(}bI%#PUESs_v*8o|@#S1| zV^l*SZ)>1q4MvRF%_&Ghsa2hmup009!(Kx?`F3572P^HFd50x5k zfb{&G)b?jsDUfYBjkaqN47PsgRK`%$|frmt-LgsAE;ZR9Qgyj({m5oq_Xd^lfGnzX8gvXD(>l(Um{1rDl=FczGR$7n%j?(L&VCJL9kP3 zj0eqCivdvYP>-Fg@$#yxypup+|*PI`Mx0i=ssa!8csc|CqvCuh{oL!OM^Ir zXSQyDFgM#^To*gtM77gZ-zFhamwl|WLo8ESkLLm5u(wSiA=e^=#-?Ijd(+}rO`)Cc zC(6nUJiNu|o@|Lc2lI9lK)nR6hA>9OBFnL{#3UujjcC+_icpSY+Q8shm<_3y)w4H+ zICO?{>LGYy0`vvOHlRhk`b2w+r6AwIB>Y5tn2CHcs2*3xbJfK=Jx6k~@jd>N&%h>_Z{ki>!pT91-2bgQ$Hrp7CkX#_*ph-Ad`E>&e51_h_fw za$oF9B}Yl8qGoTBm=71$O7pZoGeikQ`Xb_{_{{oGs#Iw+v6Kgos_MR>O~T>$s7LBc zPF9MIp(D(85<2lj81Q+Qyj$YgWK}MQisCEKaw=gc%vCGPbAx$_dU{VCeW?6nO4s6z z_kkrqedl&GXk~u9Qug5Eo&)aA;Vfe}YI!Q9IK>djcDZk_G6z9aDx@Db7(I5KtI*i) z;R6E6g+t@I8>q_T_R=W!eVg(K(Ex2P2O<~{w1X%O!&yQ2X^t~Qf6MGCut?kGexay# zpx{H<>4iaT-EsutV+BzEy;k$s!p+T}kJZ#}r~al{Gq$egC!$JP&mTZ=XYM)mTP z*wuU< zGAou$E5`0GWstFgAt znPkt0csXGl7jGp^Vt#8{htF<1jbm)UhGnGD?yGXU5I}ng}iyTR_K)Ua?-Qt64Clhk}k21mejY%{g4b60F?gt-Zg_%`2sH+4zTFea# z)>!**eSI>9yyWJiy>+*lTfiKBSxu4@H8|E6F(!a_v~JB=f~XSfiLAmLTfx2uhnhQC z_Um8X;(t83xA&zmiGE3`ET-J%m9f2D&eEg#Q)^!S2j&YU#|+XHVg{fu-6?OzIFqhF zZC1+Ey?D_{CFS%_98MOmFACLNZQZ&^N&ND>YTFgk9?&yl-(&Q?KW~LS<}wB^Y|zNQq&iYfLKq8 zO0cK1)NvbEae;tA)5PcwqDeLSQ?A>is7fnJoeX68+E^bG4iLmadQ>VtCU!~XG%Cz>hh#bR7|=GppEv|5{kXRi{Q(B1bxB}W11JSu# z-(o+bui1wGjPxl8iIS~1{bv0jv$GSV14jBx8}ESDrt!`%vcU_1xPR@M5x>q)6|E$K z1*@%^#{3~{(Dfr?HYUr&JC*BT>xF*goOO$$M0OG2J;l5;vY*~rkKVqiym?e*YN09L zrlzK|U`?a}xrMl~B7@}jS*8Nuxw}mePd*#$!IP-6n3j{l+jps=Es4XP-u{rwdc%@5 zbjCY$zUuX&;FP?!1w;w_TC7ebczu;Dm3G_T1!AdMN*XGFxp1>i->I*1Yzif~>e>|l zK=P8-oV8UG^bRysDULj4?1@}%2A%j$Nui9Cs9#f}R&T>x>uUq+4ZAy_-wlTK}k zRn-qZ%ZKhIp$-J|ks{7*p$&F-JyoFhvE?5XKc|xXg)6*W^Q=j+QXn`! z8wMXP=GS#c^;;lLcG(FZ5gRMx?p*ErwT@A{k#G#tMp-F3_b1Z8rZd-8P2A6Nxo>h8 zN|fz9k|(+|-oY7i4J`(#B_hk{Ow=ljv-rL3f5)r;F)x$U?4(sOs8v111z2*jQh(NU zYwJdMC0t7d;`*^SQ5vc=&60`^$aVEKN9IY3S%U((CQx=;mmjAx~3Kt(R5S&)67 z(ScjZYK<+Q{Q?t4@@5mM$=L9D6E`xI6fFq~H$2Pj#Q)4!c6lvBrZA3AUn8OIftr~o zJlacJqUHeHw-id8nyc{L0E2y+%VbpBO(rj0rD3bwr9ubkiQ^BDYDysL5u&pV4ZjF? zUnOpOrX*ryng`8a$Yo3a237Ts@%$GN#eYaQ{yU`oH`vVIiu5l?#=!I+e<$*=KAnuX z&RH?%-QvM5NY+iem13-<|3Fs+7}D5yuzx7YwY4!!cb2)+tSY19HPOsR&u*Dl;pS2o zK#EkXWiKD_WLi-yvaY$obsbbUK-h{`v6CuJNw?4+MJ!b=iYb*pb@0*eEZcB}>MKZ? zsZ#Ki;O42P=do6}6;rq8YT*G9j{c=x|4z89_h>q9!=e5fFv2O@NAoXw)*`rnLuiNq(wg>D-*H~&Q565GJf*eqJ#~e17-}c< z=MRUUXJw=f^G1qR`vT5ppV!3BKkDeI*J_^`_L7%gQ*o6sN%IA2!Q=iBg^7Ezs}}Kq zmsD{FVXoD&Z{Y`OH|S$N{Y>Q*gBHy;Unpep%te-i=?@2Mbd@fcizs?Olj5=R*j)|A z{YquY9RV)py7<=A4jgxFhZq`mqRTL>kHq;W&gUx6K9kg4 z)4%fG{VpASHE#)fvz%h%ZNZljcpEPqDkSrE|4F5*O)t08&BuxBdEXdWMn(MZ3HEud z?6?b4hmY1xT22EE3MT* zp>}H+5IK&OS#gz^EM1}{%%A)8a#obyCP9b0;Adzoe!te`bo0d`WGtcHxsA%D?`84c zkc5R(e6Q_WiA4~luTyCNRTf?EQLQEBAbrP0NxiC7aH0(jUSC9ORidED#!kOk)=dri zh|}X&Jv0t6!asSxK&Q|cs-@!s>$PS+=uK7e9~gM8 zfOI(jY4UCT%Y}>#{ z_cjY{|6dz<|HUJuvOK+!<3XOMra3j^if;PwYx&=X{RCv4@~PGQD(umtEN8t9%qtuEHt~2dGz{ zfHCNqBQ3;T%6yE+5afN)jSDGB$+RmX9Gr!H7 zd=|~u{Sy(aEE%T5A(>B3L&Y>gr?iB`jwxphTP>(v~wGmgjnbR8HZ232sxEaC7vbYNHX zHoi-p(eI|$@rIy}!F{A@tNPb)_ue3A*X-a*wGJft*`7>odkr~F5p2E8JfD{LugP@d z#{Fc^pZ(jmqvcLXu%(*Lf(CltiYu{4HTZrhJBn^%>qspCVt5Dac}$G4i9^8LEUDt2 zwga`Ks!3IFu?wmC{xwZxbK8s}StUsKxEaWB=IGi8Q!J*F!<(e!I77o!Oo`sqWWsO8 zk>wv+&4{XBAQgf6++OJU3(vzSs9YL&NNWOtC@^^*a@k~EP!bxy$gWb`9LOh1l`2s= zC?AbXe6X_BSFVO4)ml9j7vj2?+@Oya1u(`l6!;Gma~z#OLgL8{uRjO9_Od7T^*N06wdHDy~oc>(yNK->NgPpERs)R8O zr+PCv4i`VsaTOVwy6Iv^gL+IoUT7l|p6sd-bEUL;`)r;>D+@+BSix}%R!6i}xCz(0 zw8qwGL6m=tCX8%NzmHWMb}C!e(Bu17mZR~+`)N!b4)vK#n6sAeBXZfy{^NxZ>3Gdt z*hVWM;p*6Xbg(~#Esr^8<#(*BXygW746^oqwSFjzxPYmwaeg3gSmU#cSf@cX;}!#$ z=!NGm)=$> zUIy;l^efF&0H1P>p5nCk7DHSW;mnykYAj~1oki-fNF4*UY8A;?J3r-fmBma>FUQs@ zEG8(`Nu6z;OGt8yx)o+LSnm_xSF@Nn*NvuObj+Rz3kBD--a|TOnQ0+T)s8&`PAz#c zTMD#d)#4=)Xfq7?N%~zzxROBHNHMrphd7RPTn8zL_QJ5_=**v(uAFSpJ%avzwCCZR zTaG1Qm#Uo5;S^M;6wEckm6vbUJ9vZxBj_)IJntrQ86~=|N4qFFcDj?!bH&QFF9>x3 z0P)^7*Xg!vPhU=(WAraD4zNHz^BQntZ{7v<9;}mbP;d55+R|FnazQ{ncDfy0x{7>2A60#;0t*3JW=% zeGicdh3v4P@Td)5r{GePI)DzZCaItD`?PbYK?R>@djq7&=I9Kra#Wla+?_qRkv3lq)unSuR6QO?|7r=WE#2JHCx5#k+if#<4q}C zJ~2;%97~5!#tHj{0}XjY>TPu{AxnAgD03JWhrMc#{=Ds=U!(1xgdaq}o=9lB-DZJ~r{6NLbjGjjxmuGuO*gdpWwre$`Xl$9u; zdI~hg1li$G6!zc0H&hXlBC@CAi@D=bm~B&8;<;|5n$OTLrDO1g$Z*HQ`cH4Z`BlSt zypDm%Y)r)Br_T}8g3DD%E5HyjlcPp_lP&o|2rp}W4lvt`vC)J3CcpA-LznG((G}r< z5a@>ZQ^1Ns^@>N-X0#+0H$TJRg;3!Hn5aw2ROG;+CX!Cp&4N(n%69x>ipj{5Zah@H z2ld2w$=0{6YX(@K<|3O(fz3j5!2=56R)g(WzaVa~b?mz6hUq&n2c z#I0%r+!}jbi{~;+t0E;r7TGIFVPTI;|IDo|md41rsjFO?n+)BE*Upd@?12z57@MxS zN;+b!6C+-W$W#yJUrSjiEnaAI{S!><{e&{y@rK$-R5KJK11^-)58W;9R@+8V%`uef z#_LIqZ5gVTk0eOd)a~la>!{qkB2TDA>sgkh3k(y#2A!E4Z8|=Fn1du*yP@qBB78WOKdFQ|gb?2x$kev%Kliemy zCzFtthVyP1D`@jh3?`d2VAsmWJehdlK%1`+=(Nt#Z0K_*vM$VUA=$G|zoj;35uz*WEI zTRanQojNJdjW#tOcSD2GT|9;Ull)y=@t5WAw>YNDy1QEXqQ)~(v$xzxi_l2#bP9OIIXY!v zXfr>@MVR(b%xqi-CtPu^T7?ZMyviLAq=r?HU@OOb6~1G~PeO;MIOaK&Ap0k|q4G&Y zfoU^B|8bF?1BmIEipUq-!aqQqe(#MoB(Y!SrAmx~AZB`2Z7j8ht%gR z=FaBs5(V5T>di;V4Kpj3qxDyu_OW5n*n`lL5qjhR(%0)4F3qFHlJw?ajZRnbx@(zA zk*c(C1OTY)ohOxJY-TLMA0Wwb48m*C)JH0)JkQ&oM}UF0BLCr>QOfPb=CtEwzNQ zmfu9{c?$HT%c1Yo*g4IDqU0%V6}-v1P~I!D=53qjTT)Wo=?`~S-l?`%m&?nY^}R;8 z!TJI1>MyebR);@2QOXY)4J!~`H7V?WauS2U3>)<7o1Z+6ma=_!`-(|O`^!#Yu>(%R z&SQMcbhe}3PDIoFV{`F5TDIjTJ~@iv(+X+H6G+6>L~$64myv1DJ|feTo)C?0-HCbS-*L^w zN5_(X12x8UO=stQJML99M>wS)`?afrI+1i4O%1mwSH7+u)O(;zwf5Bmn1NOPoA4Ef zf&Y@zmfEC!Mt2sT3n7a@ST#hukzajlH!=~MZ>~)rzrC8=`fIwOwdzWd+t!Y5I@EX4 zWi0vG`b|3?21a_C-su1ljT(+IFe&~s!wrH#*Wa?&>JFpjiRkbJ+lc!WbPAK6sy4u+ zrnp*}C`@BLZ7i)vecfdL_G;#w*+pF=7#g8m+4Q>YOFsN$AfB*U3mf&B^QW!-yST0= zU_8=N=Fz6h#XX7tKlHb{7-t|c|G{)3+UeHHI)xwNR%+V#Y%T_^s&2mqLhLllkf+U8 zXNEnGuX$xC<2G0W)H`orOBQwucHOM z7HpBjFF8Q0`o1K5;`eBO&FgKRJ~cU*?7(}_$`?~ZSsgAN3ofZ9V2*syAEO|QD4-yq zU=WaCP~f1Tpdi3MP*f0777-N_mync_7LL<2qNA`=2iU$N3fu*y){av+q6s`R0F}FA7XYp#yY~EX@kPH~w4A|GasV zVRd~v_N@i}&-H&7>|dv~BX1_PDTI4el0g%2$m9Qudz7Th{mO==N8l2cmsbLMkS1>nGEJa@}Fy7q8%CM zYIgrj@@lsItc9u|Tt9cY2*l%CM%n|b-2Y5LMoNEM<`rn9QmW$X!Xb?hP@c*PG7TNi zMSqrAq)yZ<=MEvyS_NMVK)MzbWF_WijxxAO6ijsU%TMi1f9WAlq&b%KktULMeMA&F zSxBk*?tS-OO>FY;leAnk8iOjy1E#^5Dc`*(18t|3Ji6PnV!>7atc?II-P?TohqU0x z@taaM<}k*$T;*ksIKi$6a4!STKtgKc-VlbcazfkNx#bYzT#*-I;^9`SZ1)j;toW~S zM-to>lQ0FP(U4K7+VXAz_@((^X(M@%@>8zpbI|m;lmF^Zno6 z>P`frNJBY@hi>m#`{A&M;ZM)ah>%1|)sOfZR?H5E!_NcoD{lAq$0 zL;H$3@%tYjL4KS?vM+yt)D;6SPm@bIez=oW24i!p(k2jqd5lRVmCQIyPeUX}$*#t+J?A8x| zNu8gJGtI+qEf3H3OHD#Bq?S(e4t@>kgLz^L5$8;s zP!ZZY_pWTY!cb+0dqvcSWVYwbDF_P&gp5}WUe^Kkj35~ovhv|>c3;Dm zvRr6Q_(LwTN1@}ou-xjp)4RrhrV2pta@Y?viH}aONV>SkEJO0XAAiFsbPrfn1d&}K zj_n2Js=74=ENgRW0!mDYV#6Uq?_Bf*{@e0_t- zu;XJjV-*g*evse_HLj*VGF^H zfTYqXa4He!=~eSAihi9*%tPc6(JruUyh%*v?ocYjR8lQoYkL7_PsbkhdIbi|!=Avg z4l4`ncJjLx`o~&W_kz~IMTHgwO;}t3^9lm*c00@g+C`#gv4q*ZX&+#Gl_M(8kRHOx zf+cRbT8AIb=*fo37(r$z3Ip*R7E)hHasO$B@a)t6sO22DJ5&&r(H1q)ZU#EEFv8IN zCTTRkA4;PRC2$T`#+j{!%Z@xu`ZUQ^FUjNl1j>(%w#)gJaN}z7O}=5586dM5@oULb$2$;8cKQ#yxV$0qofTE zt$^omqau1QLT-tXLc%D#OOBLio7ii&t8qa_FE#wX==*<$E{*a_yViAnjlbPtTw+NB@*14NKR#?7>F94{C|Scm#`m%X;2Q&u47qaiB~(jb`!UGnAg1HKW zB4xgQI~SG(D_MU~Z$ecq5F{epQ zIoNAz$+?&zVKy4+EQh-->Cw0xqFqKkva~=_Gd`uz^Alt!49ALtEDs(FDTuK>j=WDN zk0W&(UNYC;yy89;ZdC5ZNxYn26|Sh|m^f;0V6JKeS^7xXosW?EV*As%DmQewG!OEY zx~*}H1O7Q{ym%;X9)z)jz9gKabw+RDMZnfVRUsn|Z$-JMh)(bRaZpDah1LJx7H)NCtGzgix4vTiY)StZ1C_^~{qFPDXjx*3)Qltj#K zxjV_+KJ+H1yK8C7LZ^(Tkq3cu z-s2j@#G8R{0Scznm(+fP$A%7nFfqV3&3_qwJ zOdVXN7}d>o1=))6S+!^3H@Y=KgL>%m$IdS3>ynqiJkxKKY?o9zsM-Z=OXhf$S^|Oj zK-fx(Bgbd36gXSDFgYzDJmVSu=*%z^_IGPA+S+{%1kQHa*4kd#{BzV|INr{! zPF_@p4c#UDP>Yfxr#}vI^-@+V>df?3Bf)55J2fDmXS0Nv z?^uvLW_*YhWDU;VaI`*KDdo}ZK%e5_t}4zK*Q^XhiIixmn=$3#Ai=>+K>FGiy}+YP zLZ&PWK@SAf7+wAX+ruWKtBACrAjzvoLB9C>&u$Zg1Pcr4Rw;?z^VcV;Fy?%t*yqhv z)#enLC2rmK`s6IkN`xJyXfpqOwJFpy%y$R~6OteZ-sciS^0+SA^`m-K!$o-wB>t-h zdgij^Z^yUBI15=sjwL}K2q?2pC2PgxD}>yM_1|EEY5gUkoR3l}qG$Ws@hcin>ehHL zOgJdrkNP3KKB$v0@x&xdyH*Av0Y4~1Mjez0h)EUL*AzRbMxk)-;uA43*QNBoaUgl{ zz?lvEo~|~2WMcQM5_78>{9vMXEd{wEC0YG_`^|9w*&S$?J!uXKZ+oHC;YsP2$vr>W zvm>M~ety|(f9hkOC#CR%el{HXr9x;Bo~k552%^U+MWk^}yb3(5wt?~@_;+(+C9w2` zJC4D)XbvD19#pZ1<04C5H?F$UEq-`%L0jK##H>4gFw|21{fiay9hWR~>%U9XP8h zYw}&Z+Wy@b2DCmCX)91#)8zWNT;&H}(|iZJBC<5w9||#Qp-Giu%}SIgk0Y!SPC2XI zSDF|CFJ2skih#L~*{Qy3l=r@P9db1Z^k-(m;T6}}oHr5#$QeZ|!IxgNVzhV!Yt_bV zh70@Tc*Y-=Y7YdXhhd7%rk1U84W>dMS|%uv57f!y&OKk~`L@>L%`KBpxH>Q(i_=6L z*JKJPt6<}r`i8!*l{*V=I*FcPi9~GXIzIWpmrst)8m|bYw(dxFEL;llWnURIDM17d z_kty%qfHq7`80^AIH=<+o-zpSq_X-k&olKSCh6Us77uQ(_Md>+YApfFOr zPNYk|vg0GN{a!5pxG4 zNGb#G3fU+}HXYOPpy`FvC5egbkDv+-5;A#s25VtXEx#|pccMw#jL%!kUy<#NqB+&3 ztUybK78!mL=Wq8R9hIV?BVo4BrT8}Xbp_U5Q(P}QZ{!-IgXsE;N;fi ztsOrZ6y{(#Od6(Vd-400`Q#8T4UXYa3+xoSA^{n?`2wGtDr@+U-@w<_rCAL!pzNhs z0_7v64J)VHLUAFd8D(~~>-*T>w&f0)Fab?tSa)ptHJ9ENicTbZyyw` ziI(_$V2kz8JKx3>4cy)`y6vY+J?W(nAOLyDoCML1%-cHOp)LjO8i?{_R~)T|?vSf| zdX}JhOg^&Q{PvL}-<5e%m0JD4UQ+Fc&YU`4a@xuBn2i|m1{X;LRX>}wA}9W7Z}iH` z-h4tfnx$C~gasaM5c4~N9_>&D5f>}*4XMKgL09==M>eMcn{oykvwHnib_GIF!7vf4 zr8x5@{udK|^peOd!Ff#X4r8#m4mnBT;e4Y|%z~&Z?0JaeaoR6;?|aEF2-gg~QfA_q z!2nkMY8e?@TD^xS;Lxpv8V?7^nlIBUnM&1imSQ{7BiZQKhhRk}B)W-#EWo10Cs9Y! zG1Qpmj=ym7#BV>Bv9*D41_8ZK@lj-x%Ia_Izsv|K6`UkmzWKdniUL|!N`0b?! zaQXX&C2Rg0BZ>Fm1rRY%=A;ZAYwf|R@^(dOK8q8FP-v2qi@rs!pT)R4ZMw9X2d}uG z-7XFIX2K|to@*K22p=?GVMMt(m@J!d&Bz{*JVLAU5y7NFBpM~Pn+1R}Hdcj4%gf!# zN1nnKUP~gS@AKCZ-GN!xqy2(svPCuXkdDeaV#o1>y#U9!rn1x@D@2w>+6o`8mffgt zE3c&r*~(=05Gn$W?JFPkV6pFc53O!idQI%58fmWi@=}%+@dq`jYDiId`7Kss$ppX% zOI11L59L|Csv{CV^cVUb>mxya*f1}+f}^^OuUjKY@4$6=6Ki!GXBC@eZnscnGT(|| z9DRPglw`ETME>R7xwo0{Fe+#i8^4VdIB1^PFAk={<)Eo3wgSUF6Do+Gf{5y#uD%i! zn`N5ZWq>ok(xZyIRlMhLX<8>91} z+AfJgneb<&mU6`*`sRRxc8QFw&ybmtI>_0f6aJL}D8GEK1TSCoRdXXj_ZCpPq)6xv z$SISdTLE3`KS1Dqg#J>Baz7c;n-5hQq@bM(37rsWdJFcyQ?)Rxm%ABS99kunj`;tLxe$CZnSuBcPCN?Gvphn$& zk^7N_Wxj9u3!Pms34PwGve%TIIM8^q|VhJ^sg13UIl3v3%BhrLc7 z7aXKo)(K!Zxqb3L?j5mO~0`1jZ zw^R`B$)>sC7Onou-NcrzJVo(Mi+8rGq&g8z#tYE<0c^EnvVTQ-)1-}~tQZmWovU+4 zMWS2n{4*;CouuklGaQ`8O!S3e204+4ZyXr&D!+DU?j}}d8L!w8l3_KQo)22PQ$1q0 zIncL(StdO@T%HwvnO@H|P4HnJD%<#=8Er3m_b~k6jJxF3r^1=cI`O|`qq)QQVR#ET zSlyYJtJX#ykWw$1$DM2%VFOG~uYj|!?;CL{X6@*yveiJRz-%xes8rLxclJ{NAB3u`=+y)#}oDW6?rpXE;z2sB@cL)G-5)6!4X0;};qq`0vub>eM2PEcprn)YPP+ z8r^}Hn7_iB#pTX{L+Tt>RA_7z;sU(@n_TAg=yaN29c!MY6F@*&_LTw!*~v!l$ow3f z7zSBLeEfYfnF_&2`C$e=3sBe&QpW5}WXpJy|H8eDq6h-fz~QgD`NMs)#r}b$-5~ZT zuSD^PV*>7ZPvLt6)HrIb<4jK0-q-yqgbb7fBFyP*b87O`FqPj2rM!{2!Z1%a4Yc>T zPrmmeNJ19@22m5cAb-AeDZZuCKSZBk639{aQ}x5mgua6x$Xd0caqu=wXC+`!tb**5 zc~vYaDX97;pNYyL83&K2GX1P36dzm6)eCEdn99;sUndEXF;guM5s zOSdl`0Ctqelj>HZ$wOjIAO~CDA=m)i2Jayx%sNK~7;jWh=&R%3GW8)!X8#r?4qm4+ zKA&8S`}5EN$6T~$!G*9)9?A~%Y>l>2@0~0r-!OD@zH$( z7r#wUXhOf^e{hRqxF)e0$pW$&;c=E=P!|Y}_?C3OOkuQCxi;CxkEJTzgX3`j+WJ$; zJ<-4;vzblH!j#9zAHo1?EF#4X4K7)kS_T5+so(qPxAfE1GFT2)f<0`x*XFjOa^ne3 z2&ec~5YqD8mFhJdWe%j;uOd6ZAmj3lqj_xLRG_*4J_3I&N3Bhe}nZUjeFs8t6-*g4mPGih9;MgCGDe)id!CzRSG&5n+lTc4mThFKf) z&FG{DmE?m(ft$*X!^|y+wcIq4^2Wh>=b(C)FiA(uP9RjF;K`zaTY~da88ow7Jk6Ox z?{;o?N>7jK;cycAq;lQ5a|$x8kYAs2LEt8Dx!wZ$HIX9(EbuNtj66c!#!#YH8> z#>AV78{Tu)Fv8iz@&_N9DfTf&z9f~6gm~6sh454(p|>#({z-x$(JTvX*mcqsY$^Gq zpEa`)E0vXr0fA*K3l_Rv__QzUmkAg!ZU{-UxAGeq*mNSkm#+ zNKt_CNuZ(FPQ|2&mCQ6Fwe!Y{B26A;c~?^Cehn1oPG9#98VF2(FH~}eG)J8RFJC~H zyA~h5(`}x?1}o_vnO)#DmuD_cj;0csFVRn-DX}naJa#jm+Nn%o;Pv@J;Tjb3d7WJE zXfm6w_i14BYXPwW613iGIxr~@C5+>@ZX>}Q>XT6O+fRTj5N#+rgLN(r+T!ADEtvJ& z`OKJ!$cbG{&+bLhC>PuTY=wMy%!Y$Wyv?_RQd)z=rHWz3$vdabc zv3j%`W(ucnzB+Nt(o;O~bnXMs>G zf*f>0({_ZP7q#2~{N^giU*f6LNxAc01=3buwISqgTz|=P{tdAv2eJF{^-mcePb9w& zg|A~xLj$*|h3d2Qp+b)iqAD^_U(yBOAH0=UwB@J8uW*E-!#LE+8*!5r%u{A-ckw`L z)G%3gsDJsgg&Cyr!^VUOSuO*D6$B|WqX-%!AoA%5JsO}ZZhT;`9=ib}Liy9r7fVwu zc!!|pdx8Y+T#joC(~^=*!>s$n*ATdP5ZU$$I6g1!&IWs%f{CiR#kBb(doqAo93#PW z$i*Pe9r0I-Jn$yXXx4-6X{(Fk?U<~~woN`UuuSMx)KF;j*ouBNJ)e*AP(uTV^h_Lx zx|p8~^W_qDbzOgsA*WASji*D7883_92xxbeXNac0EAAFyF}C7@@!*&?rcO&=@y)41 zR0ru8koV2i3vsK~;Sd<}1AP_3nShP36401s;mJ@EON<;&i zefkg#cd&{#Gp9@v$yCAQBnRx=NzM-YWJK~Y;y1r;E)jy$P_{nGI*2J(wG?~ADlr;- z)gmU43xb!<-xuq3+NHcRUVV{Al*KGhcWpoy$VjwydtV*T`V}@8xp|UHk?n$KDEa>K zHnqA`kDsf(gw3K2s7+*L$Xs7SFenv`R*UnVtju!O-DR0fjJ?%+tDVr(Hr7dAcrx_H zI}0Ve5<@nfZbOb=BC%6-0q^Qr>|_T8Q6=!OjHyXthK0#^aOAgK$3+ERQ}o`bdCuNxTUz91TLfk3Ev zPGhg?ri%-l$3?rlKg&#Winp?_8k9b6+*fYojTk_)Bw=>_R6b&d z6Htz_Lb2cTfy??4K4ytanf_F-CsDU%jB76~(M+XN->Vl`RGX$E3 zTEL7GxN{|!z{Ej9$~Ts8wA}M^wg4@re7;kV;u>jay8IxcWB_oc;Co~43;FH=1?n)I zKH319awo}DC{@h)sO;+J44o*pxE*MJahDr7zjL+0;lG1)^@3X?VWWd=Sam(0Z)>r| z=12LQ)n~#bqR4@OiJOFz?-evSvKwg0W-@~E`*H(x9!`+<2z(v&vz$`m5(n1F2V5ZQ zP;;GyUu6H2`cz&T%P=+iL=zrA9Nr&Vu|PCXH!h1&zuWb6=6`(kuzT56$`Bea5GRv> zGv)s0(|;GvXwJB-xY-_L|Bu)H<5!R7uvTqnC!_z;zu)*@MGvl(tC!-AG!=7<1#SOz z^gk3OElFIRHFL`SPqO`8*Z{k&xfhVwT&zznYz#ez{r@T=ekh>T#Ih}Mkp6$JVNk&z z=3==^;Kz3iEonnRi=c3Sb>UrzGi56d#$b*J`!HQ^3e&HE<*5!fs3eSX!bu+GRFyaf z`DTg&sx%`#au=uv#lXX!c#ux-My>>_z5Sk$#aR*-O6P(guG*j-kNEI{?5#+F$nhaG zF;C7X6LR_m9d{#)-n~v%gJQ#G;{gr%;So@&4V--(m*ei@8xHhN6oG?N+WaA}qOxE{A4SnFNBl=|BvDlqtCFC7* zG#=(-+{2ysTa3J~D>>QBld?(PXo#wBSSgm1h+8RttYbP_8q{&UI$n7$BndMy!K_br zol_EG?{!yF^8Nbitu)~KMddO>&M?`4&tnnVMc1-?HQx&)X4yU&;?SG&oJ`>(&CAHt z_X$-FyFi9W#ZiqxaS#x^v=}Z3sP@VZeQ)Vz7L4Ju9@~O9RciB*5?L~zeI(zG`b+zp zBf1*kJgt{!HEoM0le#YOxvCe}^kf{Rjw7_aw)lpKlur4}&BEe}CP*?HT0@htL8s~S zwOJB9ZfUog=KgEuVT}$+FC(n|$SKuuM3{wg;!j4E_Qo80c$M|+nHe9bdQ213%1{b3 zBBq$GkS3bO?lC0;r{}RRrNrDrSv&*oVvTAJhcD^gtai$>?_4=@?}YLLyb(z{E36MA zu`KVIhr9SW#(VuQW2bl8FK6MzPw)*YDchGJf=8c~)>k;I<*vRP5Yodb<*0dn;gl4a zi-aCK=#YDg6siuN8h;%4f<^%;T?R=e_J%l;KA9xTvg4h=C)~`T_(&dG!^hd`LfT2q z{dRS|6jqDmF+-m|8>a@WP{l?Jy)SZx(m?6_4Rqb9DL%||vdMID*5^H;r-%>?_a}(S z?IIKoL0s;{K=n$X_2yQ`Z9xeh*Uh!GbkCd>IaASJ#v^h6VwzGP^@lN%B{^i>h6w}B zZN^O2NA{{Ls>D`?58fqGo4YHQ=)Pytrz|B95{oGg|ByRVI3k6yL{PG4V*S4 zjHF0++`ZiDzObui)vZG{1!gfH4Ts}wt+=}%7?)oya)3WWczy*T+kyECa_RIJghi4# zsGJWed)N>Z7DOdCiW`4$gf&uIG}vlhHG@CB=I#D5124;$%k^=Mm|(%uSI{L2pQhN^ zP@R^cch(exhu9-8pB>LH%k@ZksT1MkiAHqu^@$fvPt5zVsv4Y}pu^t}OM`YP)cAqdKLIoAlh50|)TvSHmM%&Twii=F-0 zbHu^r+yZUA3+}nkGDA7_uip*F5SN2np0&kax|I;k2fiCSWPY4Zpe%v_=UBsgJYs=X zmx^~lT@gV~ye@fpRO0&O;yb6sIGNJlSu|ds8Ml8&+oOAJUf=a2^7O?==RRSF+&uF+ z?>S&%-mh5g+$Z{{m*>QRsb#fU&ic5bCc{#r9a4-W^CLIXF)tc0wMvbp3c8!54j=yZr3X%K@va=ZyCDl-A8UfQh z%)VA0KsPGK{rTEv)!nWWNTQWA&z!D^c%y<)n}E6Mo+cwUDr3pv5iZ)qj@W+rH;TD0 z^haa6917;-?R0~z<(8U~x!o^2F-VHDjJ?sn$a7-ZHlaMP_vJkM>2U-n^(a7+qGM5vWXEt{jahveX1O?c-M`b6+)lNA z2GgWqpiVJ7qZ_(l^put~mP_N|n_lDszM3yECx>Nh1Xro;yDOkafAdo+25mSM zXB|$xKd(w{ib+K|`J(mEyE@y2*s2a9QYTJon`@W>uPaFzKRTyKke%%fw{yoP(1Q`y zbLQW1xY*OJA(y8`=a)6_)^ZB^kb%SZ=pvhUjW1pJDO?hXE_>X~wZYdl3`a#vs_Ktr z4`z$#i#E`8oXj<*LuQ#HUfr#JHD?J7Jl)p{>2I(u)gV*(3TlL=bG#q)z-Y~KH=SXa zdDZqs^Gw)9WAE3W>lZuMqf`}jm{kg&IvMtxZ9H?7_gr`H!JfL4tDhWq?-a$Cnc;}c z3(hCJTnOou`dV(iKFt>$|04GmJWD2pc*9dR$@m5Pj6i zxMNPMJkx_R01rNk9rI~b?E#)9#wY#sbbG4c&=?l~CuZ4_@fOCo^c{t;kZ~NYfjg1B zVNf?N>!4!x@P*hTMz)|nIh=7PBm;Q`$8wf2@ZBDNDa%Qbpf+;PBu1`U-2|y-Ok$NK zRnk{7?rsfYBvD+8kE_)ddILS4w4FAr$P3{mJk4EeF8Q+=qSC|%eIfXpded1vb9DUYsDkuFH{H_ zNOi7_%;c5eRd{2sb1L6=6Hc$}b}aTA=sp>Ho2xo$LO7_2L-*Wd!keYlR2hb>x5`&s z@$OoY$y2NZ^iB(=J3D-|K3ektJFu!EH7xP;xMfCQhfz`jXf@QC_|c{|^&0{_ z%~6I#zQ`sr*(YgM4c8lK4<8vwvYrN06Hh!u_DWJ8F2$RPk)%asxDo_RP|9(6+-}nm z!0e$u$#LA*O5UO@(8FjZ9`C;N(wZ4pJY*Bc-SZ1!LvRMTNk3iomdpFk9tCH{?%QK+ zjmOGZsA7ayCE8OR_P;xjCfqNho*#Kzj5sWGVZ#orI3D{_qX~;3#;q304-F+nk>nZB z75foDn{950hAF(6j;79Wzr-*jK{lDM`T1^>vtgt-@_Gq#Kc>Shn&mFxbB2{tXD8x> z6|QAkfe-L9N`c<6h1f!a4=RTP+d;-IH+_!Z$Sk_)lwN$j`;7WBn;bd>yIs*JCe4!i zHR?95{dni$Ov!+b0^`@uAB*=@dFOc%;;p!eCb>qDBuiq2#(xl$&mOILLTirU7hqlA zI3n=SdmlfM%-J`c zEtS`?6t!SfE#imUvZB$Td0L~4a3s0RX7*X3p&DVMva@u$W;}4)){%?4BkD@aQQsoA zCF+%}o60ZFe8I}O5`=Dh?biXnRfo@)Y-c|&aj)nM`5AG)^Fm40IRrBe{gfAlY1IE9~YE+(T|8YLBM%fz05z($W>(BLCPV}iR_U$e8125HhCwa1b|L8+({ zr3>@>*ygNx4`D1xlbggiYmRUSxvJ$I8II$Vckq;!)>Eyh5D2@>Y@bZ%kyM1yQwTXt z9W^NW-2WDN8kmvR;F169qv6l;BTY%)p3z*KQQ(J=NM?a4Nva$3ms5i{*(S}4Uo*zK z;o2R~8^|6AG!LrvCD+o@%(o-x)0`5;H_&dmV>ohzd7QZOHX>gsAMXyq*$-^V$w?ZW zhcJBJTlZBZK3me9QA8+JI}!Re-Ye!U7{i`Dtt(0!N@DrtW6q#6R}sU&a8tAu*;tHB z!({pss9DdIYt4=!7{Hv(OSL>N5&jz-L^m9-H)*YpIf8Sn06}AswfTNhZaG&A!@UzT20_as4TTdC!&4RS+vO zNQ6ZnI*V0u)cFa!In)pf&jQKh$8dB02J&2Z>2c-P{u-86_yJAj&-r7trs1j!A9Dk5 zMAbc1M3Aj1%bCTSrYgx_{AewCH(oQXX*fi$<x`OP5ag`V^FUeMh@jwy59}O%b6EVH!j~k`fkSs%iCW6y1=5dA*6MF? z5MoUM&s@|#B6BfNp*l>*>N{e70e>P1cBz^M^Hni{Zh*zR%|}3w?A+3k=T>j~?3~}+ z_jkE-a)L&08iwZ`*|M;Sv^(Zc0d>%q$uHTjro! zM{%;Fptm{`$+~eo+jGt_dbx8?6&6}8e@LD1D!t#&k5`288vIn6;bl?rRXHyg=_Soc zp5vVDXZVUc1F>^7lKIGHm;2mI9#lIf5zm@Ek!F#{@3y7dH}!L@)DWJw7uJ zB}(}~T0C}+B4;*@CWE$bmU)rtMfTd8Vdda3g}a8f=de;o+~8;5F;Z~aOjd}dWuxYJy7i<3Z#W-6g+qd5zh;W3 z5wE+jP{Y>+UG6PykfdU=&3A0kxQt1q;^IHj6O*iAm>U})pC2Stbt1{@d*){uOlFA6ZI-J z+W332%nChc-qD9Vc#OkSb^Xbr2q-brCOGtjd!2s6T1?TSBti~Ksn^0KPe-4!KvR;# zZi$Szc$4bj)T8^Jz+kSO&IIRW@|m8)V;}nts_3!DNtf$Y``1qw;uTR7fPrtIju+uw z^zu3_{YJ@9Nd3?Ul^T%48XoQVc$rp{%(GJz#!8J29>&$q6uy;1G0zOo2g#~{&wT~O zUwj12CL1p@4PSb5XGtk}?c!t98^Z!Y?#z^V{maG6hU~6>?#+;y$)Qjt;L~^IV+BMM zmxAC7tjd~aU-<~5-f_dHpC-r?YHBr1H0hjkxxDQ4A))&LS6V|4DZ(mv(Z@)nI7R9~ z3y~QC%ck@I=A%HOU?ca`^9h2tv>z$wmQv!5%hN2Zn`3!pZ5$^uW)z)Js_*k;~(K_$2$ zIl-8P5usC_>(`{+dk$xAI=X8thc&Y6vojrK4LOBv;_OQ;tcdAyEwVNNciOV9>W;gn zbeivVBttgvhXPoa{^{hUt(*O7Y$Mt!9i)ZEYpqzlmsFQ?@ zqQGfFFTWJ6v(W#56*-o59i=BWbCFk5F!T@?!SH6h-zkGea;l7BPNq)9K&Plx^oc1t zVyKH}ks>Jcv4oYn?JecHS-nIojOEM8@-&`t#+Cg6;TCx5Cr*3?;RM)H!flm{tXDnd zOV-+C=1#XcU>Ue{YN`g8+B$QAtLo;WlxFUd#1w~d3dS%9JYva+KkDZp2Jb4t3-sW|CC1MF$i91kbUt%GQ~4nDQt4AkFxU*6S-NC}_Fk6%%dwi2+vdiP>S^XQF~vL|0sOm4|XLh&pf=0*`$fIGX7 zOZ5ZamRd1=XdJEGFDFRJKJwDdP$^(?KL?wR`}r-e)K-P)%XcRW-rEH{ z6TW{7DLu`bqI{l3ip0>8$hbnnQ`oeQ6<6};H6coDnd@tgT??29PojG?^2o=S0ws^8 zIyx?9yw4CjpG#l0IgG#Rk3D>-ru@ZLyW}xBh}~g&%+>IuO0>5oHu4Duh!Ts-?266P z7sd{YB}#c$2?sjdhSp6mztoD8+A!v<6$F86Gt|Nb9u1G1ci`)WA#N$fNKE$8;!;RA z%5gP_!9>rCdu=EapO2<9V?Un4b|VP*%mdZw1QN0K&+8N+-VS-%D&b#2&Rp^>jI!M! zvE$cgQk6sBofHJpl61=bxAa1?xl3kYgh{@8X-Kra4&T@E&Axo0tH${Yh&8Kyv;vBie84c>!gW>uei{OpW&2 z-VE=G41=$@==WAmx9N!$Nk&QHi#8?G&1BazD^xT4<`boqAMqVaY{(JsJqhwjgE_`8 zpG%$#G<@&RGqRR(Kfx!OGrOgB9F#;fA66XsQQgw6G(6$sb<4>e91B^osr~=x~6sYLotm#3599EO%8`zsgLwT(>TMc9iO+eB~a!Goe(s z`6cR#M{-GZ>Ga5fUK5_hJ(DV4*4xqp>nOC|8#5(_x2~>w_k7A7%`{!k=f7iuXFsV5 zmK`4(N*r{>Toq$ajZ(%fyW-pLRDH;Z#OYL^*OX4!@?&+yjsUqVppDrSbSCcIJ6bo7 zfkoqmoQ%=tHdC2tHeo=)tRh#cBJ|o5%gAqz`kZ8>g--GDRJ@E*FH0pDx=dM=+)L|j z?!L)Cg>vtEz@Ou#K<@MCWskeK%%*@W#L=ixHzjkv%yUR7sVxVd9K{aOOK|Lr!GCbJ zURD?td${t&(A$#pnp1<45VE_nvlHC8uEKq2<;!FwiFqARt&5ZxZSrHCrb5Nn5q!W&z$GFu3<2%o^&dURXwvolKRilq8u(RUiO=q0|uUn!8k8^-5@%$DY7Bs#;NI*PNy&EB<9X zvt53u;9RSNh?-PHtSo2UWH`%VLk^x}X5lcKKscL&O3ZxTWiD>J?f^bb1N7iTZw|wi zrrSzvq_EUp>lQAIm4ZZmlj{Z_tyghaoa}~2vlUJfo;(+JI@RJjSU-k&b9}h$#XX; zQupI~9~d}`a^IRUJmEl|%<#yjseBY;VbmfAWCgi%JC_!d{ifs#&3-fL=90h?W(gk! zmJ~=b6`>;t10$*FP4y`WFI)M>PpRrWx;))!^Ie)G# zJMuMgs8l?Wu?Le14FS29*cCjM6-!b7##R+3D%8EI;>#HcJPqv{bfv;-3H6=Bi(f&H zx(SzFBkl&-e7JQ5Z?RPg(^z#@oK8GPYjV&x(h>Wad1pkO8zSNXc^_e-&lzrZF*_~O zFlo=3EUYQcb*d$$@lcnU`8QV@A3pGv9wGYF@pfebU+l0NR;yC-(FbT5_QNw}nH^cJ z5xIU@XD^Yk2(exuW)zkQ0@*}@F5FHaZDM;SBnf+6s;%b+y;E2GNuQf{W%)RZhN}jT z$5884OODIZ$mnZ}Iy9G!aVupdSc?^;hM!PZ;@7?mI$x#0HX}Han)m3XPyonc#pr4gj^1y4WNU$5~r0GDw(|9IK2?GrU<>da@G^2c8k#49LN$0q|PhN{= zh{6qF(+?=0Cav31cY_iyfDc;-)hE6-)=Ds+j+z`zsdhGs{v+X4b zmL3}!rs+tl3y*+xP#sJuX!-EjK~`=Ji(3IHJYi1H*V~uJsw1luJLz61pH_$)upv!} z>3Cz!(iX0j%Q_n+%G!WeF1l7O$Lx)qB)Vc#u2${1-rGF2(oT)uH7S!4s~yRX}l z#MC;ilD{##_yV}Nc!`pen=9P`v9z6NU0GH=vjHx6Rje%mhL0u0$|Mvh zo}|Gg2%EZPc)SarV3HN)rlEA$mDn=)qZ@ruPd+iXuy-p+=tjEOOw6V%&vBevDLMjl zt3?^Ny)`J)ik17g94VD zju&PhOP97;X6M&@_~CJ@O`otQ_#(6U5DVR-L=tRS{JOcPjA4@c3z&;Mt2d^UX9H}t zlnbuCNIIO!C`tw8%i+6Aalu&N>FLIEtx>+lsdpZ+hn`nayD+EF$UPSBPu@BXJlM_1 zm<(!aS4n6gz?{qo@0jJN1dF#tA6?Rvot3%iiR+_oPU=Ib6u^$Jv#(5_@qNOPo9ZvS z?=8K!dD3}M`EX<;!m~V^!&c>kyS=-=6AKnmC0)U~k+hCG2&ZRYN-lQBrIM#< z?bw>sS5UysHK{T?M6DK8!Z z9s;~)_f*d+8ZVb&ZaE$F7~N)R(b`!;zS(a(!+%8CyIibhI*ChgF_Wf`D22x!d%^r# z(Q#^dFuUHIT^?p~Hx~Xpu1(8OswT6H%#vQX~vGa;txZE3%nM zvfvcNbU+!Sv%DUqr2*W(8_4R3yxMUb*E+TJx+;=}@Xno2qK~prm|{j(vrLR|IEC#d z1aYQ_96~d1mp?lip0v6$`s}u|=)_^|_vXj0YhroL-_T0H#ms$uqtdc(Ei)ka0t;+PSuzS!F1A;xDG@JJ6IV#t& zvd+~~%RZi?Megi+>S+)Y?4H3Uxets-4ClPtB+bzEupU~)Uc;iU!%#OS{!_4tj2HI= zR^I42uPjuAuP`nqFguOEr9#~5;nLv-B9%+OJrgmZpGK>LpPQrw4f<5D@K)G~_>}m? zM`h0IH8|!M>Qc&X51-@c;`1dKNSj!{@p{Fp!l|2{G9Inu5flJ!U=YZt?I;vDYi58T z>ZBwj2YELcQM7+Zmkq}R@!%ZwZc`n1k4R9GufBGD#b_0*eDr~|QUagn%Qp{=1Y_wi z({w`yZ*4ptd?B)#e&?G_`bP`z48lL(Y#(^c6&@&RNSOEJklJRs?(6=DD%PdTn>JrY z3*XPSK7oF`f9}xK2mKfQfr7dOM`~m9EXtp%Mf9&^7@Fk6aqqZNo-wg9Y39?scEh=I zc{L+*y&M#AN)Dfb1Eao?kq1nwu=j`ayqC+3ARts9jQ0Yh@J?^v#&3$|45R8?w=1bg zQuo&TA$Ob(#1uYNCb*vUYsHgc82Q%?0^^VJ_O~9i{e+hXX}t}WjLnSSugE+#M7^Lp zJc>6mNz@qjI6QJD`vU^gNe46H1mWWv^l8IglBw@AU+0orC?<^b zvk=q}1II>`oD*4zT)>w?K2PYGtwmc4vKMi4_GMRUJNizyu zKom;blhn`{%|ZhhCeQM^>KLiVcXgbZ%v7p#R?-0@;#b%rZJUfNYoa>J)L^0D@$Bj7 zYga_rq!kRbWZXPb%bLROV1sDLd#G0J%x6>OO{eWlLyuX+(Fo=}aO6USL=zhtQ|pVv zvapyhaAwdh_~8)gY!gRR1UlBJk>h zG-m7biR0SVnu^V5UptG3VkDb(#LdlhIb{W!nFtb#Vi?N9rYZ44Ni-Y1qXJgv-R~{UN$FE3~%`vZXtO?w1Tf%2vv`Fn09!}RK zYQB_lQTO<(=`W9n>M~Uw$O1b}XKt5e7OR|M&WSG|1k3Zvj z>f4N^V)-uZ=Fdej4Hl|?bcI=)1NiZ0E#JK7HWFV%1wa%G6@ypWK@X^ok6g-{yUKM( zctO4IjNt%l%P03lFgN)6tR=-KBiHbem(@8Ng2lc^{TtVr`tNB!D`R&Zob#CQ_mpNl za&@>y>3ojX8@!fJC>j&K0VZl?*KS?4L2Q=8gca{Tr2+G%a@%j1oyec{cZEm|deaVt zs|}o>#TebxcuJ!sL`n42hoYiO(l>ZGQ`A?EY;~1+W`vNP_tZNT%atpLxCnj{Esm>K zzk+&K<136jLLy#G(^Algu?`_5UmIliART~d>YGNLq93sn+}@g-ocomeXk8N`Uzcpv z?2+l8&+cbIpqD5v*PCuhL*DQy;+!OPnHF{S4aueeWkHBWnykf7HBj6$zdc0#(QwXwb7hzoBLUxgQ&o)#hk5AZbHuqA17$e)~Kma56qdT zRIp`G6s#d7Wz=C&ynq_ztE7k!X@g=iKe{9$=XG|{HomdaxvWx0rO94Et9>A<-!EUx zVUt}doybK=su@So>l65rv0O=9%&@`b>r_CX?@V$W?bU4QM&8U_x?tI=(nRc<|6v7_ z_hdYUk!RS1q?WO?0uxpHk%udGM;;|3Q%pqYgeFqhHaPB)yC|Owq8s=UYhP8$MGzn? z3_K>!n_-Cz?SgCFakRx_X~|)8OuBfw4^@ZPt7{u?Jj{PD)MghF*!17Ul6+ z`364v4IlJ^&tPGkYV+bNd4V#y>JXrd18!s!!nES*7I4tI#}re}mGY@A+`cGC)oMwR z8Ws-0X*k0-bc!HLJnDGmliR)e&(5kUKM5SEGsbckQ5DIPyjUsVa<&*ts5#)(M869^ zb-f7^rrnm@dV`KEjaQ7%$RRt6x<2WZBFtWk<0)={a(+fUfv}Gtj9B%SCl4LRr)!73 z1u7xsHpk*x-+_^q_Hs#>%O8;#$QGyeyXGpfzWQ8Hy~os)tY;F`CSQwC(Iz(DQ>zP% z#+FUiIcrbvfNNPB!^6>DzK-SZqhyfnO#Lbdem(uI#U;r(WXttqhirvUa8VG7F*LQd zPfI%TV|+f}8`!l5C5@k{yb(A?^y~%jbPOT~x|WbDvZ#+vnGMCP`~*Wlyv|k2E~@5O zRFi4f*PK4Lz;TY-N6_004u*crZTBc_Pzq3?=%)_$xIqGRD#$#G`jbtOgf)+`o`+CYkIZVE6 z>Mbp89&wlzXgNJzYnwspk*_Qw9E$rCza1AbmdlC`L z>;&l2yOUa^$9O|iqaL*z+T~2qyqkJx5a~~kl3PUF4Vy3XkvMl#hu9wtJrls3mf56)QixzI z+~lhFOFL5ZzHzl)=e^|$gO1Vd@#3M6cf{gY`WGz?IgU-gxYwCHSz$H1#;-#X0PK3^ z?^!4A!9Wg*R(^L#t$AjBd1J8>Wdppu zL1CGVy3LM?h;fJxe}%-t;w;rU5-!V#F=otRM#?2^RC!#!Vvr7XkALV&PJX%vbw=7t zg=0yM!P=b^2FVfFjkb~0B}lJPmJf#p^Y4*+(w{n}V6rLMqf4ntW2@BCsC^+96bz<9 zdgh+yzySH!WLx-?kA?WAOtM&6n9ZFITqQbnZPhUO(Mj#}nM4y~R{_uamwO_D*a&zu z^`qBb@^k4wTsL=r>92Q}wi}slupWFk%#Qgn6m|T>QtpSx#J}_ z88;DWK)}y~2g8H_AfbE#`-w6S- zvlaYzTX#X=Xmzg3oIh%zc5rqT4zi-KV+C}8l^qa3z$Uw~clEmr*{*(&m0cg?x7GGU zx?^rjP=I@N?CAUucB%Mo3s~-2*;PhCcIADTJGBsOX1nq~D*uzhejlI+So-;Ys`C5R z_r(H6BbY4K{}}i_K7n>uKWXs$j{Sq?ZfXHdu+{E9Y<+tP7PdE|*kDJx|Q=TIs zd))vC2Ufv<3jAln0dRG9<&M1;|5-+Dy)bpp-w%g>Ashf#J;@9#|HW?~2vG5d!}|$` zeg|}y`8UX0yDCa}YrjUx!~7LMq&qu4WUq(dAD9ki{|+1ikD-C1AYimQ2&4`|Zach( za2W9D@^{QW%)J)>S@u_-&OpF1)!|SO3~(O(!{J@7pm^Uh{5vg*k^jbX82T6s8UX@4 z2Z6vSJn%1s1LnZU9g2vVg}z()oh3lRf-PDe0EauMB|M34i4*0w2@5}Un-v-AsfU??dWjG$36a!59 z3*lRUdkIIt!*`?j2P^*cd1;(*Oa#au1V#cW@x$S5|G(kvB^?LC5(g5#t^5P?&Y9l>-zEW#07JK&{NeEa`~iL2v;&9{XSyT*t?+|{ZJi&sVEfSa z6OLA9$1UF0|3=zRaqX<`_YnRQ;oqtLiEy;`wEs^o{e_7==Y}ouhr`=keK)-?if=f5 ziqkvp{cGX7W5BU-3kv*ebsXWmUkiV;5bo9|?m7fl2W| zqz8bkB_B}ud$xWM4nkqT{DFhvuQh97)L z*;6t2jQPPq?a}#J;RoSALjD`y(mVb=Es(ucz<&)cXs?2Q;eZdZtirec9_^>CkiFr9_eSxn9LIzT zQIq<${I5#(5&qX1zFnPl?&b8hyw|G(*E2V=^^p+7Np zz-qd0e2e=&CJ%!BUU5fF0sNPTlzk>vQDjXU9e)kDM|p>ElsX)#zAq>LlGqb7E(o@j zJs<~bf_BmTL7?9te9Pfj@M_B^r+)_DC437R`j5_hQ|Jq0F(U*xBstjO9T3P~>Hz({ ztA8i+a1#YH_x-*84&hsB|D54F=GbEuNmDaz(dv1BjSt(q={E`AuEO>jc(ci8+wIjI zyW7Gp;aerp-{#~S;Nz7KEbuuvnmO-ae8{$yEm-iuI)7);e2wn(^`yNZyYha*|2?>l zYeKssq8T19yNkK);eNvRMe(chK_yObv`Tp!(W$%+IO?aP&HmF3^zXty2>F|S-0U>k zMKO|7@-ARVa*rBhkNjT<->%LbPun;!s{nTfI!h`)3ilJft@-c$k2Qs(FFF;qF@zVx zi-0S4jl7);x9|KPl;QhY>_UsfPkO~7;v4q_4n;#Oy9)=mhuOb{aS>%Z5JQ} zga_Yi>rcw+VDyjc&3z_zgWYulM!G9+D+ASkDfHhZ`QT&tF5x?MF+jf-V*VPnIvBcB zWoOW7PYJLK>{a;g8%q6GCt<&uL*wmL+s&@s05RaZ^0ravo|OBsRegJKW?Kg+$K1=w zK^+Oy0pP&C@QX!t81$Dy%meEFQt_8s2Y~>pVEUjyG6&)@PE z2?6h9*KWE(wgXY$77)98+13&D`)_xL+TFT?1_(PhAb>A=Upq?$iPW$$A=wr z`-B7g;Rm^K5Dw-(s9mEwPC|cGILOHZV%Zbv4%&VJynpoo>)#X(ie>MiY1_knJ{+X* zd*%*wW1kPZ?Y?dLKO>`nUdnzxq5m@`S_%lE+yDWahrrRmZx;~u-@!Ej9HJEjeDw|- zbs;#es(-T~VPEq6N5a`@5%A0?INEM~O#6ByCuXOz2=KMm-{=0sliY|3|_bfiBbi?uN{d177AStxl}70K@!%1DZd0-bXn2N8xT0 z9N_AAofsB4TE^Kk`AS;cE1CCzS{@o90Nr2lzht19nD`I4D=88brBD!$V7GLLMhiYTIbAPp#5YHhE@Opd5%;7Au-^j2LS%iN5$Ks zdFEzhnWXRhgz(p^zzuhRlWoi$;aA64A=!-U`z{K8)%m#u0tam)AAI2hY}HCYOC0u~ zfoEL$YbSR>c6ERZNA8sW#UUka2^`4qUBJB=j(1lc;l8_RuiEd*u)W>OZNh;<_!rYXMt>J=e-(gm z&=wRD0>XrVq2EEI)8c6kGygZhy|o}fYl62<`U-I15tQ#Fr1<4vB5c3Q|H~2}eCt9L zn5YBnq+2;Df>t+XaoQi z5HOaqMR+RwWd&mTf1zTxE(EwW0N!4uKx^aONr7*#{;vW+_zqNT=IsO)X6T-holXBq zfB|Qm9keS0yN3P~+WzWWhZF$+dm$;%rP-GMgaFwCqQm-mnAKSK^M%WJ#g{P$S-BjDc;DNsB(CI$@p#|a1ARtHW!Fd%2ppg% z;osQU$I0Fc!@XSnM|t;3aH}1`f1m~T+cdhJ6 zt({ZY*12E@XG;K)s_(rOyVb$iudr`*f9ihU1U^9jJBR}CSOjcuU+4hMea`H&^$*JO zTYDw&2*a;xyF~4P%OB+A&elBwYL9$SurTNzh3}^Qfs^ddg}{*A&yJz+z`xerS5f@{ zC!xRY!oc*WU%)|-J$2RLzZyDdln;DBTjTv2%eM=_9gBEB#|4D2o8dcZ>fi$ke~krr zPGqOb!H1Ls{6Qbo=zDRtSv{!k9&_7j2SoH|H=*!;v<|0caqC?UMzyn)6@@FP`gYxbn4h3x*5_$&8cu~peMMgLSh}#vCVF&PTj|K8jb(#} z8BIZ5qNi{t$)UVcr$d2nhJK#bF`3Xv_f(xus@4vz=93ERh_mdG@6W?70(Rh)7O7NzdScmXq)rt#2O`dJ2K|!$O#le32fx_!g zX^uOky%5Z6i-(b1On27r(@lkfk68jQwWco9QwT;6+o(d$7UiW+^PZP%A11k29&ijL zOJ8QLO7=|4D8(jPri*UmTy16q>d`6j7ezHCH3Bc zt^2^`zAyUaIWsS*rw!@Lo64Wy%NI`N)Acu-6mp-D&$$_HTX7wFzh0pqyQM;gBUQEk zK}LFQevX0vTUs8C$CQsE^lS}?gLotv)-_}R_gEWIlEJR`8dteMbeLzQTkcXOr({P) z_=|SroJLE@H3<{Z#(Ww$YoA{uqn8(^*S+vkTwC4QEjBcVu;B4|!qp%VF4O!zNy^3Z z25=@>zkye&cxhKTl`ET4PC0!A9lz9kPiWL&pzBF21fr+iTJ~z<9OP&OC}7$`98cr} zMti(^m8|yj=C2?J;dtBf>T-#zz9J# z66hX(1>F)5^oY}hi@Q^KGztns`$oIe6|pO=RY&=g!>W2tKwerXZGN8NUlvqx6fh*N zH6i^$=A()sTGNu{>vP|BAI+)ruF za6POnGewx3(Cb=?$LNhG!I9IroMl+5eUIU8J3EM6>Uo7it&w1i;>3`SZCZisdxP6e z99Plr%dxT3L#{Fqm|F0Z_Jw#OryXsr8ZRrYHaCB1nM*7kh4sAteB|1fhx3J(!r={x zyybHY;+Q5pd>0OFW)5F*c&~1)c%}R+=z>7%QyDDV8ISCCQmFFXIIkz;vRLYv2xje` z-Xrg)%$bwmA!0Wdz5rmg=^r=(FsbVw=6OFuz-yAHAAPuTZZq>aQ<(afhnp*4<@gh* zvOH3&B(w{22EE-xm(Fv{{2T%nTd!c|Q10j>_b)E9ol`j~4c*XWhn!}T_gGh_!ldiM zwAW5|>d}fg$zHEv?Qd2&i``(5U!^a!1UW@x?xI?q{)C^eRtEG&ZrzEz6&%J{RNA~4 za#vsAtrk02gAIo%awCB6ZdTFYG4LvcUpWmwE}d8TIi)V`gL>|KMhZ~C$n!3~rIZg! zZSj7VI2hT|74KJ%;`pnh#i1T-jF;?yugHU*Sx6KHE|Xm*Jn86ts861_;eud~la&Jo zV{m3zQV`yAy@6LRxG$KMgtWWS5ETiFLGjCimAvQ(Q}u~}4-jV=-F{yr|9UB*ziBLt zx@D&6d<2eGN4UpCJ<{WWGGBbAGBcd@ZM5u)ypw$lT+Z3VI`v`rV8?U6mf=oaYymdv zE85s(b;)EH0;lgy2opv4PCu*3(d>Kvw0|bB$&}N22x8EnaM_65I#eP1u#kq5qjh&L zzPXjHvW|`C3kAJMRvVI967E;oGy46bJnJ;maUQjX0vE&<#c18!5*@)soOrBxFsrGh z&|FpvJS;H-Hbk64oXvpzMz(;w#&w$;Wv9%UlXVJSK{djzR|~Cu1p!aV+t{bqf{6y2 z6wT%ML>xP^geSs!5{CxP)u2~u=)O=Ka=N97ip%SLRWE<2RH|{)huM7Kqr`2g^6ro* zs6k(aKqyf|f{H8E?c5F%`K*>PLEC!%r7(8|af-Mj*s6H4y!W~5P2(R5@_C1?di(00~6?qR&N7oQ*XM}le7zrE7 zy@x-}O2K_F?qn6HFUdM@WG$4+M~n~{GbQ+BO~_2nSq?SBv8ukNaisKNNP~{ZbCf5W zl7meoUyg{Hq1-yQo^l1A!mv%VA$$P8{srRE- z38^=r$qMx7m&)!EOL}2`-SlbIisctsT3#E!Eg_Fj<1w=l@rF1VaP%|D&C=S;2O?yb zDQs`1UY=KwBT}G#O`*I2mVy(XK00oSx@@GQcQlJF=%lzDe!|se$_F!PcG^7~kryA;Y9Ecov#}&F@l@e}8T~>6hlHYEfhn6v(@QxiN^6& zqMVLK47Da9`W1*p1smauJZp~fR7`8K5z1+P7Lbd;w{nA?@C1I$Pqq)tNKnB_CAi}< zEUD6NQSRl$hm?m4RKSw2)@`yTV4rQrEbepGo*;U5;;m6_^W6pAAOum%3W;LUF^Zw5 z?w_)u1yvWO#!_lO>%FcU>WIFOMJ-EIBoKLoRYCELYsZ>KFyRFM+!N$UGo-aCb@D0? zlEYvYas*37e#UQk(^=p2`3KylG&;psD1-8k9gPXC%ueW4Z?^s=g0UQ|nxxe?N;SOl zSrwAuT=9-sdIj=_bOH=wz%COxC&=%}W@76qrsiF2@rk&Tv%2nNH1{N2``pJo>*5C? z^JyX*2KP?fg8;s;8)VrAhl?r(P2Y?S$518(2U04N1L2WQhc*)`mQ{N5Iv=}TUr^a` z)o3j+X9~q&_r~zG?%VdsAe*M31onHxY(o+D3UoQvIpC<2XTM4t_EdqE&wV$6 zH_k2wajT|ZgE^d3FiOCpslFK&JtP^o`Z;XKeht z`g*X(F({1=8X-w8UzxL4n%ZwxpXjVe`&@?%PPAJsX_Fj~JlVm4Y)@sQ6{A{%7T%+J zwfuy>*!cA($2;Q+-Zb?Gi0j%7S(6_v)=(FZ4kkB_uH1M}5+Gj`YO4Ge`PY%P?N|bKNwlBj9o#M?9D6l(Tk!db%tIt+PSbD1>&F*BxtJTXWG}%} z-Iz4g1Z>AD4dbS{>nRuo4~c1pF$3=iS3_N0AnlMd75bt2ha%#vb^T0a z7SCyVS)n3DLpDkgwq?`Ahxp=45t9ziX`yg3DeXk|n0q;gbRFi=lNa@PmSVmz+51wI zV2$B2hX7YIq;-q$Lo>sDNS=e@7*mOigHqXNN>90$asz#hM|U)6O1^?3P?}GwE!PT} zLT<0otRFcl$)BwNz1eo(pD~rkt{SQ@5jUVm%L?_xrwO5eU&zbtv5`Wp45exjqFW}Q zPd}Y}-cOsuvsm)~@b#8aaRuR)XhSz{jXN~%4uRnA?h**@!95`~?(XjH?(XgcNU#Kl z;BI-`d*95wnf2!OI&0OBK3!FP&Z(+X``i25)W`n-K8qafD2HWC%!sqNJFSJ@_G5*z?EDDD1mx^;~X!lSA2b*3>WZ8I94RkQ1gG|Bl#+ z^Utdvyb#)IjXzcfJK*ArJr?QlfL-~@7Q)ea^HH;0Z%e4EVmb6Q${ul9rXeXL(DmeYe$@;iQU(@Y5 z@N&iKqN4Qm_Nye0FeucGcDo|TSuU{y_(BVR8boQor!?D4HIc!-E&YA1vMk{zD{sPC zz}8w+)eJa}y4FT?@ttUV1$gCi*>ZlNL(alki*AT8C`Pw`6qw6bbeL^1n=Hz}3&f$6 zd%Wb5^S0V6Mx^iivJbuOmQ>?7+$#~CgzW`1xs^|Si#T!Sc~U|h!)4XYl=k)IG2B&@ z<)A+BLAQz%z9BgieX^Ew^zH;^ADY)m_gRK(@^HQXq5qQG9O@O?OU!~ zYVrv!{zEo>q#@mLEb~`CyPSGNgUz;wB#HgKoN>dlkol2o5pg z>GiTYI4FdpYb1qrei=|O_KT{}hKag2`=kTQccG#91*X|XDP-BwQ38Dl@ZF!N9|nze8qJ?BE9>g0r`|E~TvTgQQ=`6Bhv6 zGGg1vo#JHT>3h2vjFIvdNF5{yg&%3Ac9%SC4D$PHXaDNQPY5=}x=N2b(&A6!WInyK zoQtsOF^#2KHiIAjJZtm22*Qc!T|z#hAgD;f@+^4MKQ;tec$Nx~XDDUhvht~>s3#7LqKNGiciaW%Kd zrC=5d2ZKtU<}@zrfV0$ka3+fnqtE&_4K^@XjeW!o9>}uE6^()_MuHUB|LOu0&y^71_g`_k&yyLi z4dzQ|)50CO8?^Z~b?p~zV;@8~Fp#m`t@+G;B~k}O3@xoto{Nst?IJ@#w{MT zdt9QEq0unR?P_030|HncLs1u|Q)L+hJM7UOOZ)v>mQ^aYS);mEZP0*Mic2zhp2cofO?`O3juXl zDF$dq@CbpOEs1BHx{5OWosKPGT&nJu(xSzIPYP7()}5`lVieUdo@H(A+RRzjBfyOx znAJ#3-DL^6qP6`jk|lb%+TgpIV9FfWfL#b6-=t&FbuL90Kog9YHi+(4ZWQIEtq6?D zk!TiRr(i~xLps;Derv|`AmesV_tFlS^^DAFDXyYN{f5g&{esSXhwqvq!hRNa1XxlE>sb^^O}5RB;1bPxTA+3r(&iB&~N}|d|5z& z^y$(jVQPaB$*6yr_Qex0l|K{8$ZpENG*x^k5kNzQ-K39I*f^~THnm1A7r`o1g8dwj zpU4}V_8nOt@AR|Ry-kX}0)$yq>GH6Z47EUtFoX@AM5}LKW0ziCl;8-s?pcbiT*oPe-boJxbLLuMV1wv1f?b}!SEQNN@c)AZe~Q{!M_9vLklg2Jmw zcbOci(}5i($ypR5KF~SemH*~d4%d#Do2T>0ZM@GLp>Xy?cSo9p&?|!FTJud3bYUci zcnR#4Dn3vSjY`lTYF?ZnI7^|3eH4azyr_bcnu64^urBX?r=o4cwlyhorU?{$N^}{; zVOUm)tv}BVW&P2LJXBOc?r(j|M=$7DL(E1Jp#c&$z>a29Zpas9e>d9T!Ihgo2=5>tYPZ8?v(=I zYt@lx7et%h_fQ`WD`~MpPnZ*<<{!xLu73&1ce!Zef59)t@RFsKk=ZX5{O!%wb%nr9 z>-50Tq#|8x>jQSR#(iL7W8)@!b@YwUN@0IN1B=_9-*tJ)G}I2A5|D4 zbqN+~CT8tno7M}(8&9lP?VVh}O716)>aH*&!HeY2m3 zejUu6Fgc@xF5(BFDl#gSsx|s}qcOsA2d%13aZuZ0Yan{%U8xMjlM#HM$g#7n=r(ws z$5+#l|7CmpO^5jL*4_n7txU@*F)gM%O7PIlgmM&y9+jx;8$_Xn=TOg41h4--&PhGX z5XHk$1=MnVC_aQ=>h=r;$4oRueuyopI$sba2(h0UDI_chm&AK| zU^V^4O1_!~VV(;_!P)$I=I;N&r7!(93?|-B=M{zO8YtTfhdU;1BwWy-pyL$<5ukKn z43zi%e4SFgZDel|2tW{r9x|S?j8w@C`zev#Ftq2B{+w_8NRu*T%()fHAKpr%JV~RY zxcZuNYrf#mtP~t6mz?`ei#3VTRzHIUUi5=&{ObZjl3td^DWBOa|Ab(Mo)=n z#l1n1lh=y6-NEEVfYN7o$OHk%J3+>f(>{-cV9W>xrqDYkW6Og+pj)mu7BdLiH+;z2 z+xkIGfS3|*X=p)GOpEdx>x3a&ZazJL0ckDY)dsHK_XoY?bOm*AoWHiFbxT@vomz1G z?U3mnt%5j{7rVRcIm?kgXRBcdZ+vezCkoBJJt$kfQ%c!A(WqF!Td~vQcB6?F?_;TH zNnv6s*-x!izNNn>)sw;p(#5bLYr%AJ|%c3*OYJSZqS597NX1PE{orzYdp z`Q5p%2T}z(3;e?gLMT?}f66FH{GiLQ-GQBoq(hBjPNrDxcd642o@2Hli1>yt$xeEI zrU|IifC?F$${xLIh8j;&;N#Jtp(aMlzJq@kN;^VUzujHRG0Wuwa;?hHo5$g}9i@ncl4zA&!OVDyb!FmrMgt{%Ww&>f>}0bF+@%vx7fUR)_8E}B6Ye2+>XPbGct{@ele~-Cpco) z@Q&D)^EJS-ZsBuO6_E`(EkEZWMa?7PMMXAc{tZv9Hq_sChlCx%eLIO3O7{HRO?*TK zS~=_aT#%FpvSG;Oj?I$HWR58`mB!YX6I)a=*;JyFchZQ5Sr&aaCpwXMiN|lwuTtkE zsEbe1rp{DWvd4hC%^XtIf#JX|s6vy*mz@TdODIcEm@GI*!uZ=%U#HW?IB*+|HsCfu`9$W2nG_SF1}Lb26%rUtF65PrYY zJ%1EjKoZZ=N$+N@li#^&nxt|uwdK13-A{%U5_P;5$)Hl}H=sL|*Y=eDSK>O2v)Mm@ zwN&b_X_fI`-&Gc%`ObrvH`;`D{I^K={{S0Yp2Lk}&l$(;68(V+-@^zl7n0nW!%$IhXhdBb2aWz*l1J$0)g6imoF=LDZ!c&&c}#5yKh z3{hxyz)yRKLVwg2W`YT^^@uC0mN--|9-psuZ>yRTOzILznyQF77QXx?Ygc)P7!A85 zyOIVC5D#-(oOa9L{!T6GMl!?Lw{%T#(1KK>ZS(v+(Gb1}xk!3l4`t8}%9K|dOdSu7 z$dbd!2U1c$BNXsZSVUQ`jy3Ck5>;G`mp5L|=T~^}b$86G_L-X)^7s$1#n&uA?NGY=N}oooXa3vx2)=BkzsAHX^c^&n9xMTl zWfL{-IJ1+WlUqt3)JU7RqxI#VU~WRgPpz2kQ4>r$SPtj(+;`tR%bXbZGa^IR+MV(_ zk1%9o8GpYIqtgMQQ=wtPM93+QikeyF5sxKI$NcCzJ=+pyCJ8-CZDa0cPFqA!P$h^{ z*Pg1Bn9Da1eghmT?YnTbaLV<~8?G02M7Oxk3LCQLJJtvHTdO2(QKPVStC~0JRM^i^ zCriZjBo=fi<6pw2r1hC?g~!$R+ltzWz$>zja7RHAYp431hU=AIu@sI#+L@|l{Ca4x zGXw25?f~@g2f7$Smxygn$j&S!^Xs(P4~7dD^2FOp^51h1aDu#U0u7t&7!iaq9cax# zKNDvtB78yd2g^gcDh%*L?Qhyy(TpkOJ`bNlme1}+-<_gw#I&4JLp`0mQAD}Y0(Cc` zz3m*993>SkCi6J{?F1iI`+xwHj;cbV*|wi^H+UnQU2mun%#!A*3ar4zODckJTO?=7 zPr`-2hJPlT=C9P=IXVfW4$9ld>zo+yggtH&NCgN5-{pHqD@dej?d?v$3u zi8x(%%K*l=@lC-F*X8FQG0|o&l!B5wInMEG^s|5^#!Ps_lrp%*00dbW+CP(AYHRci zJx^P|sWV~Mt;0|c!amw+%JmqDtcyP<%trZ^VO6uX-1Tu&17;Yp=cT>PClPo*cV z;v6gv;rD&`l%?qFn$-b2%XK-%-Ehbu{!XeU#^Ctax%uG0A2oX#hC>~i{@f5?RCfpkW_ z3Mba6v;E0^pK-kCn4o{nei;IBlpw?NyKyHDP0iw11i~%@NA9LeVLO~Yzp3RS=n=yv z!;|g!Gqrx8qVJvi8ZK4W!f0CwJ0I-RS3%VpJ~@FrO^(YTM&?&?E>F9=E$);GL)c5@ z_yKa9=`tFFv`HqUBPz$$!kP=eNwsnUH6)Dr6GlTP!W%AYV?Q~7Rx@aI3`xOmB~*5j zJH@-F)ojw4e*w=4F>rZ$h9lW$DKNno!F-*57yXKc7i-tC%}iLil_DEJQ%{kvet5fV z_@()wx%!cuv{=(Byk;2TRj*P3^1Lv2mp5GLg%K^Bu8!Z-^v>&T2-~6SKlDHm-f{Jm zNFCzmSXrCFl6A=Euz}4Z&ORaWm}o28hT1W1jwmNV0Cek$gg##3?>FP-n!(;~W1PXKj(Wgx ztIXUzN(gFkRJ zPmj~A7Z+Pwuca97f61j};Qs;m@DSD;m!@a?UjX2or*W2RPCtgptPa8!~54JWj`I|C$Z>wC_&O{}8t z&-+V8P6@*JN2=dZO|sR9@#CN%a`4%=`-E6gdBufg*1MLy614${IX{IYCLkwJN9vKX zt<+Qg4IMm*KGkt`8EoGPm5&K)P$++~Y0>0Oi=`Aa{Hsj|K+N(_|D>n@rNM1E#ah(l zbXi~R(n$R)LN_e?1jlSxv|}hUG>3&WC?a(mM&5#^-R}V`_vOOXz7sbuE9yZWzKJ^?X;7_j~YrjEzU_Uh}_W?ayX$?LhUYYdk6 z+u>nQOQHYTGL?8PdY-5aN6N`MijGp+#IXr~k^^fjrb!j25T4Q@MUdng^V43Fbj!j6 zP>A7YFqRFHRfRA;6pUEcFu-WCv9L_35D=Hp&tYn9p1X_OufevFSzNo`W(H$K;A^8e z(rRq+y`jvOA)jNYm52lg^Fh^4i6{!+6}5?$E3H zM!C9fYHTq)8M&Ry#|k@r?>d{Gy_jo@8 z$i#ZH>D=shVDRDSv<21H^}|zhU$~M7di0Mud~WIyJ+pTU(zKb%ub0iDLg_NjrF0b7 zbupEF6hZY!sIfcmi?wi*uyz6xH?U6EK`JfWGMUYHje;Mn3Mi};fyp}oY~+o8|B_L2 zVlbd+qB18M&N zQ3AL>KDa0BVjNR|JC<=4XewFx z_?D#Tn7E&wbvQeW0v33M7c(j*BU)R_pO7djVI=HZgoA%J+j!92vjj3`_9c(c+*HZPR2sA(vma7no^|=vFufSVnOeIn-wkvw8y}GW%4qU-}!nQIl3i z3f6B2{(OU}0kF$jcF9?gjjeGM`M)%K!6w^AcMXl_H0eEsw)^POk@*v?-{e z5|hzjk7C*sbKZ|jdB*EI{SX)SH>;z>LhBdWrn953!+Z?4zrX`WDLn3_=J=5wPXv;2 z=8!?GHA4I`!x{>~&&`5P820A8z(R6i$=W;Tjr9JS4nE6@htI79%aFjQV+ zA@tKG>f8ZQ1{wlJ3vuiVNh`NXoefM%Ihm=DmhhB$&=;3qltfazr9`8-$BBrKa$dR` zPz1Gq0RO&Lk2ot+vOT&z@i3WtLsvyiFbrcGP}|>F)trw5sqd;oy^)MO0$qgsr<`$R z>B6QiyPPo5T-V_5#4T!EB-v~S#jMRB3Ys`Z3tOqE;rs8A#&U>y_V9e|WBeK(?%;%W zc3tUoj$e77xL%aq1Uam@NfA4yAchG){;n=JB2>U_-h8z4Kb9k<`JEAOKVu>~s;r0Q zYozRPy%Q}XR=8`sV%{GZNN}{I%49$A9i_keRlt~9E zhCB0X>WQIs>x~p|6IUZj9RMCFBY#X@OQm$X>$_pL*%YG%%aCV{$ z6k&DJh8^>BGtkuI;tBRiQjcl748=)q;R9W

    2+z{%}vzE5|1Y2NZWovwWA2{q?fq zzwt`nP2mx101%u`1X^9}dd0KL6e9IRxuKM41uH~g53gQHiFi~U{x%~jxK3XD2Po4` zM70fbck(VCLKB~9m8pV@^U`H#YbT}6VCRwf%7b3|qAoROAB}UoPRoVM9D>?>_WPcJ zrJeFnYJ6EnaiL3}DxTAiv*JaXr@#Zz{S%tW*cU9Y8^nSKfVM9WfZnDHL_RVwphC7$ z!~dFE)gLRk;72a7OZ)@iSb2$G$G0M-I+g#ucEtOtZTv`y)P)CMkMWLmZJR6204D6r z9qLISrxl+=^Q1p$W=H6zoFPpm>|^^6Q&Q3{GR?7eyhH5!u4DP#P`9LLIr-rsqYQqrpev^hNp@s{O#A({GC<-4)BG zK-aWrVm50At(4MY=CA5v*4XkCVT7$Q)@zJVb_I6%`eKY!%U`}YCLswXrIz#rK&oF$py-K`E=qPh9XjL2?Dn6yap6w)Uum>Sc zgq920fC>Cj7IZ!Q8**^LtgZ@QEvl$oKJTuxLv|Dq1~1eJS|u6cc2PM}6!DSq9zPv#6|*IoTZv5|pABQE6;SZ0KL+CDsANoj{TzX~AR>)A&b`>pUzz}obFV?78yrh~}qVlocdE<_oMEL$V140kL@73SaAwk(1L<@A?4pmp97d@>e~v6^Y1w)o#m>)O=Ju^JV<`hV~Xvk<#I>lv)XraE67r{4MgAxY%E6wCFokB5ToK&X}r1JU<`>#b4uxion z(>2Nij(^;dA7^uI=JsJsOFESEkJa8%U8#{mAlPi!w5HEP*Xo~Wi&^$9($ll;*!nO` z8>gsBx6!00>!^@g8G2R=HQr5)>jKq?O}>C=X(7z!>Mh5J{<{iP z?edXeB)>xU`f8-zh#gS}Few7EwA|<2197CEGNDN2GR+BycG&J+;*x!J1>MKwpqyJX z6SP{l$)W1sOHLk$j+3b)z{e2+JrXp@pT8W8qB5&kVcyv`M_hLVt#SEu#2ghS!Fh9X zyxQ|e5+F%{d<}qezOp4XK8`HOd(Qtan-4LYGb=9{*}~_?pa!vJF=-*@PLi_aV?_2f zd=msQnAM^V0x6)|=Fc=|%Nt*CAcw^g0iD_hCRkG4s?fAjf%O-yJ+jz?L&Q&J92&T4 zT%w5F;s^R22aQ z8iXW%C>y!K^7?+Q#-1Uzn(|2oX_!WoKzb}4Tjnv8dXg1-&tpwomePU**}(5Lw=|eD zQ&zntrbA4!n**$TrBxm@uUcSmM9T?xt=2a=Tp=>rV!`0rek?DQtJ?PxhGzXbg=;>N z1Yju>4-GdK9mv00Ka~FoTFxAw6t&cU>4h`1*u1_LvP*tkOe~HQp^WsC{Ya5{jXdU7gD2w77x}gxvak-UPd;rxd(Q~-11`%Zb$LUx(p*K)L1w#Md1fHO#TCa6jBsxDrBmZ1b)8L4l!&Q zZ;b6pLFl6;G3o!cQU_zY`SwBY9dOz`#)YGv3#$cWt&bhvp&5~k3Gt0Ox>b%TO??AM z-Kqpu0XCnGy#9|0okya~NSgZ}cc_HQMkMThSjj;1w3G^-;vWczQ!N=V^HlQx6L*+JA z;6h%gSlF?@5VX!6Ar7?Xho9&Q{S=@vh?`!cJle4NB`Yh=F78Vj`OGaCGdhhgupB$6 zT|?WDz*VKPYKJgi6o6fa#lxiW^&h}8JSk;(S*ID#-HyHk%cFPBOKZR0s;k$dj;UT$ zG`8r+Pz~Y$D->~eKTM3X2-B4ov?JS3i{Q`?9H=#^Dk_H8 z`S6YdBzdzQw8?u#xJ^!9ooQYaYkyX!Jrw2r{Od?6ic{lz;h6jhT=@9;TL&?&X>0VR=Z{9&%mOo#{FInSHscVt3N zd?VU5_AkxM;uWX~`Jw8HuXM7diN6~b&t6uT?|U~3QAso;tOcwuQoQWgL_dl-t^L4; z<*qeHyhv@9L%!felcwQ>3%OcarVf=H+a7fdeS?9b!Wge2%`p<;QYyc5tatWpu-cu7 zVT`wdOR4!#@;dlRGkucfd8&c2oCH^SJfiR}eC%a(n7QRYeaX+_Jlv*f8^9J8W^*v{h_a=9yt#q84Rn%agF)rN8+VE+uDfsP^kE zj$fn*hV=8h+0n1Qj`LA$X7lLEen1&-lgKnC@l#Vs2i?H^&P1~0)!=B@04TOPU9}qd zWraHJ?7WZfHYfOm3**|^R?_dw(#T54DjZywCl^7(7^XxWnA(z6wbbG9oy_x#^XOQ#DauDlZ)R z?>SI=xWH2FxAIUVMHu%_aIyl9mdZuhqRsH4hp9omwo;ym`kO28bx2JLFHRK8Ol~*i zS2^;c+9)jdH7|zDce!4*W@goPr>+kwzjGBjAm+pIi3NcSN_me@5Q;ny!ZHCwax4`) zA&+uQZDY;O3;s{uhy&fPxC zI>YNs7gL5N;s2KV1(+V!aoVy{(o)i86oCVFk-l)@)x+UJ=`CIV9HpgDP1C{5eU2D+ z3`ipmIbOK7=l_ZC?-MdkuOUlF5{`Zsof4h+$s`7c&JO-a79`e8nwpuv%n-V~JKU!F zCkMfcP26yrYBl&?y*UFSQ%4uUH`V`~K~Ssrt4;T~)$9VT^ij z6p+ca*XweCW*Da1>!TOO1OwRM^xsTrgu|4t=VMojwgY7YAK4T^ukCGXEB-t@(pPbG zMI`DLF(pSptDwQ37m~lEn#kSL?$ZS<&k>6 z)znP|t zSM`AzSURhRKt|+Y429QnckzJ!qnLyBYQrPAG6LXf z&C!lmkxwT{M{?l7U8|l(Si2~S9259zA&pjI*SN6$;yQi>X#+#vg_b^;_Zb6n`|qUB zW)U7hB`pY;r58^@BUVIsh3BQ8MwCvMZ_JC7Jpl`c%t4EOv9XIru1}UHi-kAN%w6^^ z(KC6H_elxtjoWYDP{Sb#3d{FoU4Py<(cyl^aLj1)U;q40xr${<3vpk$#GJ=>252UlVyBgBz z9G1JhBJ^Cg(F;G8cusDl4s6UlIg+6)oNV?9B=b^k+5~kwNv&2?y#kglC0LqVfA{ajwGZ?)RsspE} z&Mh}3fe;Xe)dKbsN3e@o=CtnI5FjbkOPVSgCS@jB4!Dne{zxTC$n=JZW)i8cQ9LGw1RO|CV$ z{s?@vfUQ{BJ2C=0Y{szK`Bynh&VARQHB8|!BuSZ>PRwkb-m^{5kH_VEBzZ*2$BZNCch>Vf1?@yVhR1pK(ovm;RZNVL3aQ2%Jl60jspkX?{6cQc( z9Czwh)bKEFHi_-rd*cjiC9oblu6W(jg;7;!mw1Uu;ICIH0^%SUX=?dLWaVX3lzGl zm%@3BMRkn**VWc<&OCHjXHoZ*YMmn+9SikP6>I-Im&`a12>k6}Oj<_?40PghY~+*jFEmY~w{@kJ&bV>IBfuQ6{8)*!3iWetbH(Y3 zYwh&QXyv^4_N-c$?iHM$rd#Jwm15 zRsf~W{w@FPByo=iOe?cdz+%gC#;?4lW7`fWEei+}1s?~ESQ1wKrTN-;BG?8(nCUZg zV-sD}cJ-}!MlX)~5;R~5YZh3GGb%cRbSO}U!pl4rM(OgMhg4xPzEJE*fFZ{x8cv#Z_g_f!f&ohO5gI6&kShmBxvR{#vZYa%=ZIwAsOLyFdpsejff4^Nv7-Y z+Z!gPR4W0(ul-sl;KOF0I5Z^jdlVrw@Uw4}O1a7Ct?MtB@6z+bl$PWv*s z@B22(AOQ;#fi8*W{s5OIw9xG8fwRVGA==@EN2PIXoM|P^ijLZI$A19o$#)JA8~8sI z)iCcQARrvfe|`R6Wi{B@Up4*`;`FZ8Gp@hrpNH(%Gwqi>@3gwyzDwVAZ$S$#{?EP$H!kt)5ENf59(U!jXi`Wf42EII4(C_OLRtN2;w zZh=}ho>DR#>wgs#c3wF}=ujP7Ql~^*!w3q*Xzb_m|IhdT>ufYzfJebJ4mZDh?OD

    R zyq~o9L9Zc)&LlJ#)>Am3d!{~`6218X6)8wghg;hlq#3d25x3wj82+yKjs!^__SXwW z>cX?+m=KAse#^rL!HH8W;ix$Nv~~M6EUHEFymi;(KCfpAEF=s?u#}Q(G2P?K=ZBH~^F6h`If8ohS(D*|c4MH1WT*Z&^ zcN6E-dUc=Tg73TW19zx1_Hm5rm?y^)AE<}CB9C#pk9V4kpGxpm+jrN9Vs_(@_gSP* z`<97ISISki?vojtX<04$Iun2*<(jG^C%mzl@vyfCT@^Ri+fJLaw={+SnreynbSIOf z4BiBPjW#vskW(VaCi{ZV4*LUnrmJi9=iuZ=w? z?kaJ^mqzngWy>IsIP1v!$-)DP;Nzk>f4+|&Ke?sr4ls-r8!i?YM22yMBqi&~ceYC} zU9BpNFSi7Dj!haLM~GOx|7Nes_mtTuj8Uc z6mh`2i+1Tk@e}Gg`*x8Y#pY_itfGH>Jvb^4dZ6BR?`a%PQaHibqac&%y+MPIqvs2N zJkB7`IocpTKQXJsx+d9>&Df_CGyRDF<_HB+`cAacv8|EmqF<^8X3puiB$~DIer^*= zoBO6s1&}Rsul5eD-^wXpDsNIE)YXjh6{#MIhOf%5{0S47BO2wr-B02f(6={|R&amdaUP*2h9%y1l)oZj%-4g_9 z?D?qeIgteR<~#e-W6)8+uTM(babALTtkmD%I*jM(k?Z*X2qi1)s~-B$r)?V*cBl0K zUxDXXfYba)niw`1cD!bYb7JYCRX7}D(xleq-yq5BF%_&9)lP{8rWBMg9ziz6?FJo0 zHe_VO-GTm#-3$9mSTb-xNM#kr2!sT}$CUz6fZ)X#4l1&agSr^r-!^iTj_z=kqXTUI zTr4!NB09jHJlXU-3MKD)LfJ;x7QSl6R-hh=(5MrBq2pMJJ}-9`+bi6;|qKxlLs}z&!?F4yHc0P0@Y| z5sOc?S472e{!p|JPRk2O5Uj0)gEdyEL~EKvq?@nkIv(Ce8PLCut7?OZdDEaP_`YYy z{{wh_L>VS<;+~QAZ(3F*M0tvL%z>kR(X4x+6!|IK6sIXyaFHnC1`jojbdh=D#2>*Z zN?>!ZkHy_fr!&!X#%=+crW;XuyrjQ0gc?Kqgad&3MhB;`kZ>jO4d)*wp=B*aCN(!d z8_tivN9PaL3mv=H9!=lpz1m{zrhMgcD8cdHvuP~&^Ezkpb1-#5jD|S26LVzDHiBv- zJ_~xpPJxYnO7C8EQEw*=YBi$o@^N^;-F$vdccS%y_c?^kX3DTS7RX3!`PrjCc#}Xv zy67V>mks}2l7i?@iDuLd_8?`otrU0w1Z-&15C_6nZ+!V6wg^xXoG34}Ggl2kMVm=M zllb*mPeD=Fgoyr1xMVDPGVUF~=z&42Ny$)0Hff}Cj*(@`fO2Sx z;IJQPlc}TDVS|Hs{n0VR?wOeBtOqP|P!{rMuP^RfWYjTJIpXO&FaIizEDiejkM^;n zVGPNToOZ`KKR6fvK3r=N_!x!Xex!jK{aOF%n@{Fj@ZRehB(|L#m zJsj>X?^ebz&CFPo?-g0FLZc}r+sB%pp^oOlw1cWfEI&zs(92mBr$sv>0!z>p`c3ta zO!6eUf)|Wgke)2zkUoH~6>?|nMXusF2MqK3v0{?hD!luSsu7P?@PC(q#gRGV`&8GggQI}%U)sLQ8cLqIOuX}0}{)++F%V(KXG`G6SeNmPH< z0)eVwO>6`k86VXT@&+2C(jh%MuqX&{TgZpknb-ilguwDZUl9Uyz!6p&z9~#2FBYso z(XA+@+QLVv<1(&0m^B#9Pa-UCPM=$Nu}W&~q{}qqn^m3mVySRS-So1_PotO8d7i>g z17`gW{b6B!_aYLBpp`6ddrGM^mLk|G7zl|C^B&*b|0a{Jgcse-e6)g%n!4llKQz0` zE%gmQ+rHIrfM?zbdfxWvkkpOb7M$WFhy@V|I^BQX5(a@~WN-T;7LGJJ3SkFlXviDQ ziVPaSQr4onxcub-h5A8&vDeI>JHtw%KP z>IYIuHNiavM3ah4Gq_}M4TE{b0AnJDi!1~%BKIz10swy!UQvYt*{yA*S*r;LN%Dn* zWF$>L#v9H_LD9DPxRHWD%1L@j@X4`K>xvt2$E8%&Rj}lu-_VALm1%A?FF(@s^>d>z zz(XkO`ckOtZ#ZhLubczcx=*u_)8-2Cv(^W$^YF)CuPEOakEmI-Xa{cJ!5LoMnBdaE zdD5^bMbni;4;K$Fa#X_Ud846%u%N$LbI6DRP);Fl$J$dYn&Ol#Sf?3*UhWJc1!#1P$H^PJsNGCvbcr8_~)?s+$&3O+1~Yto^wI+`SR9P#H8 znxqT17069GPRP~_#zd?98H3cb$VE)?^YD?fa?WIO7L;LV39y;;ExYb+PG7diP3^id z5m)KSX|awkf3FEt;FhJS(3Kj~+4FqytuNPAm7eoB!$m@6tfXYE659n%|3NfG6y^4J zE&z0ZQTb(VhbXp5=n6BnuQ<%XOAkLSA+-Dl;c#%yXA~$5cDx@~R7W^{q*>am z=?7HykmD@kSh9lyL&DZY6Tb#tzwvJso?~cBB2t<~WsDn5_7V|q4}b%$!g0FziQxOY zBI4G`$wa93-b}->DZN*0vm3ANzkdmq7B)xAfm3=C5bf4&tTYq(FuK2*gk6YS_ZH#U zWH!wZcPx;A>^|gSEh4*(U-O!k6pL@>b)027xLZW1DF04W({+HtTm}Lh3fqOnQu}`* zq9`Y8yuJKRq(X$5DHm`;fQd;0^LCOBWM74keH{?HCve?%+Hb z4HvJee%EPMKMC9Fs4d-K`exsjNQpCvMnL7YaaD>;u;k5vAyi}sk3Q7WVFz+;_p=lA zkJ^|dR{(pZB%VY2g1-SX(NQmz?25Q10QrST=oBS@YeNNmBX+Oz$+N9(OWT8-s}!9tz`76dbwnCzf%7CB ze`?w|DdG($4#3!^o|R%v9HdcAvVFhZDcry9?EfVs_bvH;G8Y2*2iTpIoQ_vZ?v?2` z9)pras6T%qW}1|f9;oQs&}J@SHRYyuZE~+}g2WLbNyEqFnX#ay=$IDs<=3oy+%bbs zNI@2g#|nRQiahVj_xQbr-yV{uJg@jB7r;Sq*70#&);R%=8#Gn3-yFOR1x%O~uKtI`Oa;v+yOG>ke!{&$vNdDCJ zvR*uHfe))gfQtZ7Z~8%A_9{i-I_B<;QJj)RW>(@0-1&Li*0fb6;h=o)`PfL8L6U`w z^!3{*)!t$R`Gt!$aDFo%XjmU+a&kV9bNm=^&UI9NIY(bU&!xNUUTEo}Bc5#v4c-d3 zP(EMDypekL=sH0j)hRqIkNQO&r;inIsnI(hvE$_|lI)*5qzvOJOX)m!8BFpiP~sZ5 zj7ZSzV37#3vcPwutb_#0p9;Lz$Xt5{g(;aM26azztWXtCygmfGIN2=3HS1SEL+-|+ z0}P4661I$Yya2+&&|f7PAbBtWSD>mFth;yh-Pyi(}enve$l9KW*?9@g=MA= zV<5J~;B$TVPpKj&4wYvLpM5Ymc!RvJ=*K1?ZX_Wz%V_w)ANVHIL#LUWp~iiK0$tAn zVljKL+MI=5NZ5+DfN&*ihZ>$iQ`MOFq!x4Trd>gx_i4nxZ=qnX)b7`oyk8>Z=LSS^ zfi1RJC0F>{17YLw1*c#;qyh5iR(!%??16v~Ux8gY4Bx-t>@b3?)P zf#CxL=0vRe4&CKz4k0LD0F9#>kSzpy)JBO>L<~E9hl^xRJS&13D{4jL5y22qe^}6e zTjVJJLaeGtN>TlL;}Dd0dc6BrRY+pE7^z7TJ7sW-OT5E~m>(JYP6sU^o&R~8Utdp_X^YB-OBf1N(2DIXiH_(6Mi870p$TK>u# zgP4Of3g!gjBWDQOlZHLmrRTgEP3Lb?o{8|Ay#62F-ZH3;Ale!o4hOe`1&4#XB{%^N z?ykXIg9g`wyK4w?aJPgIf&~Z;!9BPHmjFQndEEE&-Fv@#tG=rDYpQx?cJJ!x>e;<} zueJKswx`pAQ~3GYb9?(dWsNS0{b-igV#LBHJ!39x<0*v7z%K~y$Kls; zc&QFqP^{^~FrlfFO#-02>w!*lgO4rYf`bd|yx~3~4UON1;Q+vgrot2`oTN)t?J@g$ zkNH=MoJmVp)a-WzN}HMBzgxcb4jJ*>ly&UPb@!8dM5%3}x<$w$v(4;;1IgvmJB@b>lf zn183E3xI(l8O7}Kv-7@CoLtd~MFyS~VeP!~ShL>-CSp08;~@ixP2V@uP3cI!eZ4BO z%j>qmcU+7Y;kIU=2tk&WZ`**Cy()=~lTRI!Np0A9-9?epkgldy25UzDE@tym=aP(FQAX-*$; zL+Ae_+AwFv>_DmzlT7E?-^Ted_lU$FGK<={@3O`Y;Ei4mFcK09GXm_B9IVI*(fw&V z@`}-n=S5IHT{loA>fFJHUr$OPtm0Jqrc`BTA3#&=o1=)a@Wy9<*|9Q3SUC)pc>6`q zi#}(MxQJ9D7m;x}2h6CpW2yaAa52@~cs7gPdlNL9i_@n_`Nms`>l~Nf3G)!-FlX}{ z`a5jUMgLyNlRr=3;K?(1jn|)(-8)6toJh!I6-f-AvXxyjCLLwi%^_veCS?;@PQ5|r zb@V%DpYnfN~%D%P0vLpj6CSDiiL`$v?t4;F&nf(LJwjxyQU@Yd~q z`&Yr6xr8y92UNs_OeRt3Fk%M&#IL*M*Sl`)FGywj3N#=;&@?v7Ivjh?|Gvk}WFu@8 zxJ@lj^LpyW`Djd$-Sy3CN)GGn`UX&H zKgaJ?r^{Yqicue=(S1pGxV*^W)Og8IVGzrzAI+L6$2EDaKH%hJZF00@y%9ba>5dza z58uN)fSWc$bH$$8^ao)0vV`cx1n8LF0z^zF?qly+kTd;B%SoMN>q2SrPByCq1a!*}WgYlE-!ODZ5rzU@NF5wamc2{grXjN1{G8~&bFPK{GQCvT?$+u|OmbHu)r!Cy z#aCVvVaiv4R1VdiIf1Gz6_JC*yV6Gt8a3X8r?Qdf*ZyL3yAtcLB_hw%k@oj`ke%jn z{$4?SOdqz(i92-xMXrvLvHodXc63g#{g?l@u*}iwB3+%LNa~vYNZO~Bbdv%u#W8v7 zGvO^Y55fnCXi2konQrwxeJ=|D&v3BRWf|$7{l4>Ijh<11_b8z~8z zPmdx&oy~A&i2fkN$d3pRq95~gqk@Em>56{7_|~_sz(GU>k3Ea1M-&FCZ{jX0;IVNx z`2f^t#lu*@7Us?dKCMo7Okd8dxBn@7;Cmr-op2kxP40InSrlTbFzQ;W207Bg2nB>H zoy*hMRqi^NLAo-|@_UxOY`*W58uxAc9{yyJlqNx5hMVz2V{MF)<|3tg%C-{fmWek; zW7GmayW82h^tkuLSVE&bR~BTG4z|sLeJyz|5!fakg0xvhcw8Xon;~gW{zAkukqM`V zM8m~|g^z^%#exjVL*mrg_NIJB*vn!xw>4Ll!O^9`_phI3uilb6R!&kCKluBqqnf{@ z!jZiQ30L3aV3(X{W7croF2+Qm1ij2-{;sCIzxm6$^!Lp+3nC%Yfpd`GE_s?m|5$?5nAwt~JXk_Gmm3GxAzwbitd{%Gnj1vC|2|^i z$^joaF#?(~3l|&dHOCD@GS*5w03Cxi{{aM^c<6s50!74C$Alvl{sA&VFYi@u%+*sZ zgJri{Ap#(CGS>yRAtct^O(OX>r1BY+&qXJtNKHDHYYWhh>n{6UoRax-D9xl^jolcC0Ux55>MB zW{*@tMLW5NK`79>iHekbK4}dBxV7l|o*+p~X1wad5KqiIeYij+g&Us?o2Z3O)W`P- zi6I*I%JLqvc@$P9lTC$mDItGMLK!I#k6To>bR+j^asro8p;0l)?2Zg2K3zbXJtHOV zP}>aUA=&$L`s*Dy3)B*8s%RVUNCAeck3Tir;>SegwxIdZHRIlipb)ovmkQ8@k&tF% z(XM!i>WoXXCRhlZN{ugfj=i5Jsz5Ojjj0@n3GVjPi|m45$ME+WKTj8nbQpgYp8YZ@|SCaKhaP5)(tQqjn)nXMH) zhyb$T7)%tL*quPYK(r*g%^kd-{o|>lB|7+Z9M7IXanj&DDJR8TQ;!CreLxH4xJAsmMoC-%p zs@Dekn2 zIaPV7+Lsa51NqKZWa$~AnT4VaoE6N#9O>_v-gWA9jTcVbPEMB1RbSDSHjO=!@|e3i z7O|_Q#4JgCUAsbP+^Pg(%>X(}bc_3NszKv`i3BB$C7O11T>1c+)F8wYk0HWZQLTwU zs{!}*+>7su*5?Ic4EdMy1=Mta9kw8cI;J_}`Fa zq=4^XUM?lpop9qodQu?@J84xoRntvGC=iYldIegS2W^z4OU7+-ZE773eD2jO`v>qJ zC~qOm+v(o3R&uo$C1}`Qcj6zq(jn_mQs!RWk~7ZA2UJa(_y_HO-T!H`Z^}P$XSDGg z6)|hRnvl)+7RD7h`>~BjL%!{c@x^K6Jy>j{)1C7j{z7kZ6*}n_{x{W(vLX)C8o%!$cUa#~E^s zgO5?GD^TUg%2&Het2^~4Jv=$qGU0pd~$eR``g+O3e_P8b&7QX4&#<4BrHj~ zsYsBLDsmIXc+YvX*&Hj9AuoI?{SyJXc@x}gVUJ=Wpp+#F(XqN%zb3~9ow!pruSh4n z9XhmYUT??UvO3e0$WuE1@@c5(Moga}PGgcFX}TSsWsg+SB<0U0#w?E_o|n@yMfZiS zyPmyax^fGPNlcdhO<~C{Ho)*}^fYdob%}E>Zrs}wX%(}7oPytUU9M&o+gK)L514DA zLuc6UWtuGUGj!|f$X5Gfl+-Bnpd0q+D+7)Udx7tF`oJ3wPXs@@LfCPQR6^CkG=7@&h3vwCoz+I)EG#>*K$U~>^P*mjU z>UktsQJ&rr?s4N8A~CTcz&A|3t%?CWTW32mxPV3?rz%$?AItRh8lMES3R4^R26c7t z7;XJk2w%`?fM2g4`)2kT3wLf)4M7%zx-|2vXYw%Q3e7fS12!fBdPMm$0oBh9}kz)>B;zi>vDmRe*NjNi@z{heovk6;4#S zjV?Y+%tW7t^{aP2`WX$rubA|3k8Si7CG}%N{;WO5^OKxbW|T{YQfR}s& zPhO`i2NRj`%Ydrn*PTfu0*6DPA2ie{a3r{A&j`5sVb(0+-J~1=MB6GJPo*KhAgTlN z&f{HSM8Gq+h^!|!voqbS0`Z0BYw;Omx(I|7!Ig8}Q6)4l0LKYAT)vw<-nIW+wu`=# z;E5K2HVal*l5r=-l~0zG{^=!I#JIe@?_>17|5sAT)IZ=CgBmNFchLjx^S_PY?4C;{ zW~8PamHIC1@1K_N(xNs;x(pk5Pg_~Kpv3oaVgxHDFO`s`>PtAx%kio~h3DlpcbA=z zROQWF@Vg}ybYB`v3kP$$f^ML>8{3GbtGnUcT05Cn{nm3xb;c7kg6tp|Aw-YMN=<+e zMRg8VJm!1-B2g`gn6Oa6n*Y-{Wa}RQ^8mBOl)$JH^SPWi17C>GGpjZ_4>=N6_soeW zL51O|XO#bdl7GNhpt)m%2Te;uCt)@#VeubhocYaEQU#cQ*fA^JbAx6z0gt=m63}~@9C>ERkyUjm04JT|~ zTO#O>Cf?F~y}6;6bheg%+l%HC)G;7-ACo1emaRNdycbpoW08^Z7CObspe&nRC>F zK7Kdx+3e#sVDXI>N!HV&`p?ylx$LkRedad~!ct;ipWn$hCGf*LfyuZ@7hES7RLihH zJpDYu!e`9XNORzrVRtRjf`V(slTF(J%0==v9nB@$h5Ti5QIzek=(OMW)R)F#YpY?$ zxGKV(czjxf&NqPD7qk?dKq;)Pr7UG|CQ6HnDo~@o-}*<0x@Y0WsAP}yMBdLdJJXoM ztLFzD33KREc*b6y$KDwli0>allzQA1d#+$ z@Rg%gG=R&OCJ;CdKiiF+3;0Z2G-s?Ji?+E&=~4Nvj|smQebyvo;c0Sd`#{Y$nt)!4 zp#zcyicwGV3ob9czY%_eRz}oYZWv>-+yml5B2iN!OzjLx^p7~EV(7<=!Mp-_*F$`_ z;vc46N_P+ZZtklnm{Wi>dp>FTIfC9zd}tC{U_7)()*Nk)DDnj za2-CR&mRAP0*hS|MKs$?mFwdD;IX9u;lCC4LPa;%Ak@$Xth0kbQHGARvzVYyPc62; z#jhvAaZAx!D~w-Zq(s&ovdr<}A5?#^uN1OvMQrvGaYGGRxWsW4pxY<5OPimxZzPn# zN>bBpaC!&Lau7y+yRZ2T5(CqPQKfQHr1UhJ=N>Hqfgy@xtpGwMBBV$Qr_Db##LNFH zOfP8DZR7A=oi!(JWiovetkKhD=xB=s89yap`4<{|-@?quTUqar*csG~c8G_}leq2f z8g~%ka95yY&Q3UWATRukB3&+(^SAE0|DBUM-`?90#uJl;1wEIhM!8~f0JDuE6c_Y` z#&(g<bpY{L0xdM8#Iz(~CY(M3D+A;-6^jd0UW-fd{ zHmu0=&xnn)IdK?QN(6(h@pOa*=uCITNTq7^i zG+pc-O#+tb;yEdw{V(?kVMeZ-^{f6Tk1x5Y)l|GvueWvI*XgZ3hnV{?s+skhw}eXTL+Cp#zx1 zO@kAD^WP!bPS8Tg=Ec(QevUIcL!O8qHZqX2bfL&-sn<^@PJPB!9i6Gkk-T~1(|l+@ z7g6!wup7Qvjyi8V5gaur=)ac|-C&oSd%(6k;uMw-YCpC}BLcf0u~v2G^ORCbyhFY| zrgE5hM~tNN?kr^a z5h_@ijsU_d2*o*ahKBWmM;9V}5!TCxMtvHRnr&>{0mTeF+MW%iItc(pc0J<1buYW_ zFZE~OTk1`Ufck8}XdXsKzo{ySd-s9jge9bzRHCBue?I;Lod0v~8?%M7onsp)PjSP} zuRgA=yUe)xB&igOZ=fKAqeHqK#Tq>IX#(-S4wm#1|o7L}SX(RVOAjrlJ(){FnKBJ~KJ8 zGR?XwlV?qm|J)aWz1rX-&E#-8H=tEu+9$O!Bk`5Y`6Sh)*zR4J5=83Mn^^6a9Jq?^ zY6%nN*B*-;HfhRf#`oTjk&xD0m&mqH$|^gyF=T!yA}CRbxG@>#8P^(O$j%jZ1yPkK zYUXDTYf&mb!$_&FABj5%!@Stb!>F~c{D$K2Kn#*inC&GwJi%-Pl#snblXkW5cPC)n zh=D6n1nYOpO;qy~|4^$WOR{D%b54e9MyFN5BIL9951THKwSYD&q5=VGtI%}Aut zY3E$kt5_sns*0h+@GpFg=l3X)5wpo5zBrI&f@3xyCCb?kX*%7-Q?~yp`C#0}U_yj; zh*3>6-^8?SnS1I_r;CIGA5i;Vc92JIuU@8|_f3PoR@#jS+V>Vs^u>$o527Cxy_~-0 z8Ze+^IU!N8#KZ~WGNphsr6Bk+MTTMU-lRa1i09F*r{d%Q5VEAaTGSAl^;i7g?##$;-$f+*we(Np&de*vY|UaX+s9bEyD^m%hgz) z5Zx-9c$2Ik4lZkF8ovId0@Nvh6`Frp|~Cb+<==vZ|Fr^OP6Z9u@3 zf<}dHTLBq#-xMaaM2}5ePqcS=&F%Bcxk`~95B0%) zMqvah)@0*=uk>51hCCh~6O<4H2WsM_oKini7+y!Q6lZKylkALeJ&1jBna5KX7-4Iy zv^snjp6Z%VseU~WBa;W6*yw{}Q-8Z%bhT_UEs}T&43d7bb1ex$#*S!ZdHh;+9p8iA z9U+qe`czq40iuOy30eTxcqwRm&r2N#M4DJ0Mo}-2%rlkp;t^-tr|)|)1=z`tGkwR6 zMmI^tGO!RP(t$86OnLYRgna4C_(n2{JG?&QN#|9sZ(p-0p|#y;pnJ^=?P=>qLdM?8 zPM;=rXQc{o=_vRI=;Toy){8VX;6EhY%Dss@PHuB$q6j)&=01kr4eh08Xsk`xsaJ-K zom_=5m&DR4)Kr=H8+5<^M7Hr^_q(^7n}#SI#`eL)U&U_9n#rESzV0#7_;d}TK73ki zzFQTw$*qOp4{qd^we6EP0sbxtgBtZ$aetZ3&aOgaR6;?Ss7}SL0Wawo-fF1X3)Jc4 zaUBu4!jqEv@TyK?+}EWdB44DuEMEXCo-T}%rY*1Li4*z$L1F*HjP!BNPFZQ|ckaq& zaX*nIBU$KvGswE6aFJy zG%(ilne{#=M)E&^x#v6V01aK1E44U*17|$0=wW|7@x{#G=(tPW#jOqInj410IMQcc z7Cd1%UwWa^HUEyy-px2&I5YbCoy347S?TGw%ZNUlXy1_37?^=uIt|<16>6$*j5jeh zSNhj`vX|DL^ow{OLoCirJN^G0Ej0Z9dO15+{=euk{o~2r%2Sled%SoZ+Y3xg*2i-j z>nsNGW%EBZ9}2&r9OndWn8-0-n=FWz$}S5I_o^_wF(`t59go7Y36F2MnGO0<7K`~81}c)Oj(2zK#{ zH3fkR1GAQ{>Z-qc)s?8DLnrq|cSIs+sUkV)Vzf0nJZv@fX4Pnm08EmA7tM|~IC4TUEnI4OMoj)CO(%ekc}-nlzsR ziqYI4!+varg{eWxuVi%*YVuAJ0XM=wL=;G)=BrsaMSlt3n@QK!R7TAq+V`)H>+%)` z$Suw{&#v7yCzNmUR<%HAJ5TWu$Cj6kXzGndJoqmzZUYwydRpr+(G7^&iD>4(yY~}) zu~KN!ti{+Y1Vr(~AXJNyY1 z8|gXKwvk20Qi$d{Zh|UFBY9kEvcju&3*4F~{$U-cP&HxmW)P__rubjNqRULR>wkbn z$Uw*sGI1oUla*N>HGP%)N-bCI9k!PfS5Mc?+Q2E zh_Dfp`TUJP@Baa^HbKmPSu@kxK#FjI*U^YH)~mN4w2H$;$n<+cwn%lAt@|rrGQ0gR z9pgkA{fOj~rN6df=sWWjJLzSLe}$IcErna4pwQrI2 z@mvQ%iZL_5uYhc!pPHqep$gTu$FeBBN?Ptsc?Ab2%Hb3ZtuZv|28!%Tvd*#$kt&D^iqeMzB$KzWA=#n^yn=o1W~(a0yr$A_Ms_yV zim65tXRhNr(|TKTP&?J5zz$tH%N_FS(6@vn4h218+u!n`wzkbFM^WZZy>MOZ^=GPO zo=|*hnS(4!O;~vo9F$Q0OY^t-y$btn@?UKH4z~~ivm@+kR)%M!>k4z}pKbXMuL{r2 zp5C&|#H)adP`(DVzI_GpifQM>U>L1DeOXdnyaH{U2z@p2yQ%Y|?odAAMDl1K^|$*5 z=-tGl3jBpX*q#y*inzJLl=l?_;%b1Gxb05@-Rz{z!03?E#)763E-Z|;8v0j7&WLuK zBy&>N6Dt-L8A(M3d!0MN(6cV%dHY2fn0?F0^W+D8X%!d>{<6uu}UtI-%hj!Jbm)6(N&P%(TBu0-4{U zM=+8he{6xWbmN^UPW=|9m8>QQmRoz|TwoXMAOe@EV!oW7mC`mph%PB$Pa2jwfy&WZ-%r;a>g{2~Y+D#sgb z^AEKPH3Pi%v>)-~GffJ6$(1JZPLtEmVE=$O-$k<@3}PT}D1{u+O-;k3w}us1z1=+i zU{J@2beQGUG3MfMw6mUGq4BfCBBo{*aG6l}H70@TjeJQQfEpZni0hS-vi`hycF8aN zu6VHO^^v?sCtV)&6`UoaAmTOZPkp0VhUNn3+EJpf<{KBf=7}LE9neq43+dE*xa}yY zQ%n-OI{Ey`kdm)f?nq#Tk(kGcW&W7K6-U~mkc)SJXM4+XVGarOql!ShCO)kRnT!l0 zZO0&7=^G!lF~bd1`9c7Fdj#tE{8+tzM+)!2(3&jorKO^XR@RT`Az2}%0btC}G!o)& zYg8OehM}c0GJAiX;c_+b=NJSlbv~u>g|smdE0MH8cmObyhOvvWPH0EjJ?$3zbvHhy zC%Y^y*`J#oAH_?!rb@nE+(`ueYpt(I@@jhdVm(B^IO!=eSqrL8lzG{~ifGp0q&)S; zz5EBDhuparyZ=}%7F%g4+m=KT;WZP)c1*5F0B?65r4^i;?KJ#J2^@UNQvAl6Q!|A# z85R>EW*)dbpfzs^BV(CIiwxyku46`qvg^na4Q8>t>;nR}`aG=MH(lP&5K8vKsLFrl z+u50XGue7(CTde5+DEe7oU)JDN5MrxcMq-Eb@(wag=52F?DbvQ)7uq>VBrI3>Z$0k zxqc9@kp7{>iSwh`h4&7j#K)PDA`TuLrp}M?L!T!sTkF-=W9$0UwvPBXxTV#P7e1Ni z+fDXfT&AEhq@}v2uD*K^$csxFvArM{%Rt>5`ofCKDbwC`5<47Q2L)AwG#rsSBgD=R zCP7SWV`TlN-5x@JNSJV>UN{{?vwT8+nx{8dPT?B0JHJv*myNpZg_^RBn;9aD+dZ0J zx{qe~xqinAsDOF*AYP#V1Da?sQhwZPq$Fv-M>Y_q+~<98CzzUV;bcoO&jUys#2)cn zN&AUUS@RwvDq@-BH7dS`@)-s{!2S+Uk7J%EY>2Bkv2a*b&Tp=um}2!7&f?7;R7Rx| z$>+V@VWpT09OOztMmr9#-SRpgvmTf%+ie%&=xlMlb(OD4--i|^N>|eRvFW{yvEydp z)YOo{FFE|<5d6u8muZxdz!SNYY zu6sw3?K|Hmqe)~g=O?!C%VJR%Nv5sH9;NbY>-R3O_^VgUb15*ol*KnWb^x&(kQ?K9 zCUkGdbPGb)BB=>4yde2`@Xj-!2CVe^KC661>8Dtu7KZWzgdj#zaN*jWZfj-F-eXS~XBWJKiY z^Z5Jeo%2Y)tJRbbBcjrWk%UudxYjR5;Q$Q5H@FBaD{D84CG}is|D=eMv>XFo9kMM> z`(y6faAZM`JCimfXc}X`X5_i(xW7W=)GL2VQw2+bTcYp5*aSHcpQ} z7MY`Qd(Ii@8rGvToMX9HVF;lrD4O(sQg|}I8_MaLRfwV)7#BfE-tmx%ym0A$ju2^r z`l_{144eZ{=TTRbN?Kx55jbop@TJf|$Cuag_YHZ5b#nAC4$=`GiLAd^5IMnc`SL0m zGj%qm_+z^Q|EKw1&Jg$d-Ip-dP%M!_PNZay2oFcAZEib0{^i#J3c;8(r+qKE)UB)* z!`Uq=sPM&qQco193r?m+v&Hbm^U&hoYJ`wxsFAPRgtIC-%$XxQ9(4(JEytTqQp<@i zRzjwD=0y?0F|=AJ%h|}w!vrs~a_S=^-$vngS~WT*t9~$>bfEibS%ad7F#5tauaRu- ze!O|4i_F*9Q_Zb@fg8%$m#o3gQuHO`iuSAB2!|pH1*L~QpqjE@`goq*~TmgHx_A18FLVrg~1JCU)DR8yH8Mwq!UC| zIun`qE3c3#n6a?$(`^>)W4I&#OysKcUkR<(5L3XJ3aCN2qmnZRM~<$XTPQ@Qu{5;a z4$t4lF9hKii{eAnXLDrdq$&K$BSmf-V#82g%gjW2;-1y>aBkLJv>JTn=?6nch!IEO zoBPb<5NP%5S58+VJiOxXJUInZuwuWs4lr8*Vr$S(Vaf$KP={_v1)?vV9HOX8z{e`mOw??uwsdPII`` z{y#nQ^_yn{`S`V9(?MI#E*tVZhiHK9I)T<-GY(Pa5Y@@p`L8C$4dy#DJ&Z!cT%&d7 z9>{4ZY|8@lP59fS=D4ZiufzOQ(BYw_9>1Fc+e6~I^w@?nAs(~^QlL6yg=LWwJ~x!S z3kx9^j!t}CuB4urp<%KX4MJ;tW2mG$hNK3Yv-Cu9(Uit!=~~t8fXlbP(q=8df)8@R z{TRJIwzTR$;A?cu^TMA${~=I!8yr8zwSECI?&HQ}d;TDjlGg*~r=Fk;-dV(s`7eQ1 zB~vB+I4b`8e8)cS5x)0tT>_-idGZ|p0hD?+JjCfQ`Cpe!6$2qzSNMWH^xYn-NNS;j zz39`te4!k$own|*chqYi*q35>oR7ZwfIn199BTv(c2U<6xr64teDZmzVV|unz3}lD zW5SsCH&g!sHJ6bi=kKx08_m&~d3vmRQ?$_NDy)}uiN2eul*~n~)wz3PRshY+Ln3wO zL;rxeyWU-2l_+fk9x!2!dDEr>D{`v#$G6pS77gW^hu>ZGTG_f=S_&$ws!%lFyyFBx z$yPF_NV80`miIv!ULs+($@{S>P%Xp{PklUF8JWa5j320T)#;I|mWk*1Q;VVDJa6k_ zYY1)Fh+2R49zBy3w+!oORd&;9hVkuy4LD$cKGC%KAFCn@ghX#4=>?l(5dulK+Z`)l z>npR(deWjbZ~P{K*ae!}fi_Ou3lP>M;{JE|xkcMGF*ke|boS~5yTZNRIMbf?U_kmb zWnXakca#ub3nthx^)jzODmG}RyH?a%Fmy^$h{B!R1x-?1dTRFeqoIsv^4l$2WW4a% zHYvACwNxT?A%xO=J4}v)Tq^c+%7&LLzn6ZO&T^{PL$6>px#ZiRPczbvotj$9)z2le zf(P?8jO6~dTNG^j_Y< zv-K^1#D-65E|M|o(LtZ+6s-GkpIa6^7D^3hTDtd2u^`@;X?*b|jaVIq#i<=?&Ht0G#gpy< zewO}4!{WFuIXYw;uP`(X%_i;z{W46Zr-!dQ;M2y|>V2Y*Trjq)fZam10B#2QMR2$u z!op31eR8*_eS%~uK2k&z?IJNio2LBA#zR$!ABTK2xB5sk09sO<&{;$@W5G$v7}>lK z2}Lc+4b5ZSfpBSDygWs*$Z6~CeV zHyFnrb-K&dbB_`GLotE%I+FprBw6!5HEYhIpBf$n-x8N=v=~13NiR?U?3hnf(vsvqa-KjXQ z)~Nt3v{haa^$#_)Qe62RmQ^{2UwdBdRMBbSj8H}qC*B2XDw0oke-R$pygF+Z zpTV5%2}0OE%1%w|3Riv$M}Ij*En)tRJ!Z|KrW$p;x*=q7E%k~IM1;DkwL$zb+s**< zQa#UT&E7{!>M+&qZv+yi410GUa%DOL#~Kvz%51YCS+IkgZiFxFaQ@ij_-a$H`v?3h zOqLJ#^)+9C*Z}7Z^S9x%lI}!SW{qZxzEaV<>!9CNs(n2 zKdDx2O4y2!oM-gpcA_`rIn-wgW<2vfECNZz^zrdHHM)C5hJGO)iO_T-IjZokO4?hR z&EzmMhox9$x(O3=BW+Y9MA0Dflw7f6n8@K@Ii90|F^W)`*FxRn#_R#WD-d?!@wdgN zLNt#`DVdwmK0cd2DPl3+*z2;*<8j@2VdMXRPhx;%5TKkL%6Qs$~COyvYrJ^eC1sNB%kEIrxpHx#mFfgrv_o?ZEd7Y~D|f2u|t zQnAjHK)oAIw23V0spsfK>Xtqfe8p`-v&T2Wr!i_?-w(Cc#SGn>zH=^XLGM$fr5bk^ z)OprtPb-)pawIP$$IZ}|LYe-N-Dqj5rYx{IS;=P!?2;q5$Is!&>r%qeSTu;KjffSQ zt9Y*QmJqT%IkcQu+9_9-KF(6DifB#~>I+Q;m95~BTWwv~k7~9d`Y(86w}X3S4j2$b z1&g+y~UYk%DoP$f{?uuw?J)A+0s1Jp#*pnnEH_Fl}bo%94f zZmgnmOZ>^ZDeuT%D{c&i(Ed3vi4ICQ;H~+DJMxbI&z9;<*x#plPYJq6*ag$8^$RYd zt~Wm4f(I9#nnW|@{iVeQz_cZYXZ1a(=+2_y(k!5IT){&8*02QcG3ZDr?wg*KtS@=C z8V{l~rzME!l8AK78`xmVKVX{&^n@DBhTUgC$No;Ys` z24b&I=g7NHJ}`l42dfhez`}B=$GcecZ?4IzQ8U|JEE zvR3x2n;W9^KWtG+rvHZr{)av6QfAgSY9j=wYq4^RT!|LS;`E^3tJ#6A;R&$a_G}Z( zw7dpIV)`XO*2?;SJTvpw^QV8#>F<<0l2rN~t5@D=C@5DlQ(4T#X1yv)C>4v3GjUf~ zg3U>T=wTI|pVh(ZqgwJ1eC*QfW!PLqV4 zUpx(qjq$ykZ!B~%m}PcUV;EG3AE*+?v)_!>^NlUw?YKisaZg9tUH~39s=A+bt2e^b zfiL7K>2T|3vY7VY<=^t$<*uY4Qjv?Vo(e;*8;U!8F!0RDW^D=Uz}|5Y?+OBWBnPF; zu71beBdf#7{}92nR`l)P6G~nLp;`>Tq0~pv^fX@c8~M-$KBFyR2lqk?u>qU&TCmvY zHN2k%F^4`Bo<@en#HC-AQcy)_4=%E&2D4g|2+BGkla}>KMz5l@<^i0V%loNsP`&^m zE@$Q97>w<>5y z&#rmd;L2q}S9SjY^>0)6#BhTKLvUdcmvOUs7?T*$A%XMEA8fs9*xfi=BkXTsjbe4= zx+C`hR!|$J09JYVm+^PJ95P~Y)Zy+sq#kctl`^55M5 zFPj5Jo1u^glPks2y*jlyeeE}#l4fF^j>iV6$k7sKz6Xz%zC;(5q(f8kf#vooK{wRd zSxi$~3$ys+FGDcw)mQdnUXFIo&yy%DhhE^J`M_yL*5wP{+-b)kK&m9r8QoEZ*xblS zT}Nj&tg`lNRwxAfRB1m!nQPS96G=%VU-FgwmCO)?Rl~N8J^B+Jom@ZoSGePxV()2_ z+%5Y4G3@F{VY~)LjG}S6$F$$Us^nUne6@}?Yx602P0OoR2OUI%|CKyf#QgOJ@)>1u ztzw>GG_CY7ffFg|qR@`ii>QL9@NW#JaIBABtKXsMAf$U=vD&WhGdG0gg*=C|pms`2 zxET)te`ED@ohzGGjEJf4aSsM+RjCQ8NMvhRP9mKOppn*z6j{cD1?K5{W^@6bwrEyN ze7|Y)6h1wLqa8Z-{%znl5f@t4RL=t-S-R6?D?EtD$mDyRWgCAvcNLBtwtHlI!iTzlG^VO=u~KPnA;* zwzZ&rWkGd(fqw>Yg%q&+}+_;kh_A9Jii+)ybRbGsA|Pl=XMZqx5rF=74PI?}O!G z*yjtRB-ZW4&`tcORiY?Eub(*M+g+X!H8|Rt@-o!5wC3JDxg^=ff_@wkuMpijj3!)P zi%92+leKrVPrtzqz?w)@Ix}_Osi|q50*jI`sZ8UC&&r5WJXr!}H}h6qOGr`)w;zH< z6$!kkWh|Nc2yKP$-ZFlCui7l>B!fsugX0hWRN+r$_%(>~ER9*z!@EBohURtJZrC2; zbx((c9xF32wkykNpR9l}6xz0LSG~%#96dCR2}aU$Fr{q+9e?|}=jZD{jIvPt;|RwZ zMdoAq->1E!Hx5PSh(@pNDJ#22$|gg*L&$I>{)bvLdEsx4gP+S;+8oN`AGdT$)R1(> z!Q>q4B_5(^e1Wu|q>d&|{klIjrS0 zg5+1p+ysbOfNt3~m1ppOlh(%uxe0pd()=F}!FRDilii!y_OjNiv2oL=bS=Dmn+%9c;5dLz4`xj2Br*{wJpz#8S)IFMBkbOAbkD?4K|-_rxm#M%@DB!{HNfU zi}|RZ%7YSLEk}k}NLK~wt=$)9V+k0pvKeWisCmzozIuxgj5tdXd9ha)LVYEg<~QsD z_2J;0I&%y2?Fga&k(2zZtg+f67Cb?9318rOb-_E$nW3#nofImyu6c7KO847xmd7jcHW5#Ld0B@T8Gc^ft z-D3ffoc+8ZOF#rN?k!D2-uM-vNtYua)a%a8qJ!m_8jk$BQA;qqCQ$W^z0)IzIm;X35S`g5;pEVetX(bJTYM5#FTI? z3LmlTv!7!Re)sf@Cg4pg)0v!H(m9oQH~Li(8|-V|nJsZBaYSGNmt*k@H; zeUqn3*mn35$z8}_!nqO9r!&r1+rAXx?$ZL`jqG5JvYg3xGAJ9yVdyRWWld0T0Upz+ zKv!fp7ZJJcJc6?kqEF)zMBFG+FN5eW+|vAuUXti%lUTn+kCB3X6$=gkeg$#C!8 z$mZ0-L5 zZB_jorAte9B)BYrV8`mR?5`XLSPG)`Da*G_FiG=h#=H>;b80wQn$H*H)gYD^zj>@* zSLRgbi?JWDR-uNbzDRGgT+}xMLIfvmdmh4`>{bt3h!?tPeq50?25)?Oe`B@yy^y=q zGq};C=t&MqDOBFC!?IG7B;{y_s!v6kzLNTfww5EMfR6lw{m0A8O>rGedDZNx`&Sn+5*k>;9{Pe|`&o^m_C9 z7BXPSj98j~H&LuyIqvzndm}DxB&?FX8SlkdIk!gL^>~%b`I=W(in7Qcr%rx1O8>P- zZ1}HpSnfM;ViM1xj?W^m`K0kw`7Vp6TDPvOOf~a7Z4UpV?*$1*;JPTOai!Swi&x8m z|7wR}=hIH(OHv{Oi+&9$DSK@dMNk#%2;P1i>)O0#B${HkT<)gSAfM|tqHrEw#?2`L z=2%bZlOzattz(-5p3}R@*`jC1-pAqu!UXvts%&rKM!iUYAjCdjKQjI&@V$Y5eEqiI zGV8Ua;Dk$*fAF_7837WnDfDT2SNnA5bbqaP_K~W_mqZi~FbxENnkvc;1;ACsIz$H( zdhsq}tA@Rm96_5C4VH~e@CvC4shVqHvdT#d_R#C=+SvUqV?o^k4+Y~=t2Z0>889Z9 z%K>mg>?oe`FCKg2htBQ8=yFJs(w+M%Bp$7DBk1G zKgy8D;TFB69e<%jI=)LX28}Jl1#ARa4pLw`8>IP@0NK7pdR*-_cx|g#{xK@jG$z5R zpSSY_45+cbT_{rKzRxE<*hTJA`V;8nm?@rP&2OW`@{4!}fym@z*L6psVz24$$H5Dz zKAbvJ#p80uqx|=3&e{oOS&5c#ws`tZ=h|&!h2wE%5J&V+q>JO?Gyqa<;X89-)9MOG zbBkRKy1PL3fziai0eidFwqwHu8;DYlzmvMbiF>T9ye!PfDD+shbbgv-VZn`2*v}zO)EcnX3gwD zo35iiU+LV(uRO=uwma5aHsw33)X?M8^kf8s>jw@wO=y=-zJx>xOE0FB*`-5QXWD)A znQbz!3*oSy_{G@Ad_GYSWq8B(RL&Pjuppnv4<)vKT6m{5V0(*KIBWA~sEtBh!Wyev zMBdn@!p8D;;V>sbp#lrPs*%?++roQy1LchdeMa#FTsXjmM+kd^wf_WU-R@NlrI_q@ z66$3q<%lUH);7;>!dIr;cY|A}#8F1=22nBkQZn5HXZpNJct;x;$I8RZ_f+wgAL|xj z!W9>mdhaBYcv3d?W}zG>l0e}bvKD%vq$nCz(o?5etK<|)n}3O(O#7aWp5NYTUefA# z_})0KcyW8D1TNAqd zd!Hq{a)ALl9HU;}fOe&a=$9E#4xN>Qv*u~FS?5}FlQf*}(9&MSmVNjR z_MOJQF3*>5v4do@OtEI^9zJPa`;YNsDJj#5VPl-h(|}9@?XqUDmShE(53-Ty_%=AT zme-QAfsQswLBIgvOv(}Ahr^JFp~zb@LH2bU{nC7P)?kaXk|-VxH3}`kIma^k1wR)c zMPF9t7b6g&*+8!R+fz69n6~a~ z=SKqd-EXQyDGk{wJ)WQ4n#~D9TB1?1%ldo zpP(stw+dq`Tj8V0p4njt@|Z|uE(9wk?d6hm9!Ut<(Kwhk4{#_Fm#Z4r&92sC-2FV) zg@!)p*QqB8yLJaWc~JPlO;^Pngm)JwBN*>zd|zhVR76OOY1xuY8?uFLD?GGID37J& zb1fDf3&KP8Vxh7Y6!FN>D}E+UKy(cAkB{Pa9Yqj$z`+!RR{nKgRU`FfWkgJ|SZ+xP zPb#0|66ZsT>xa$(TH0)N@$$x~k$E2&B2Jb1B&dIA$b+z#Tf3s}_14we=ZFDbQM`>! zEtKN?K{Y?3g1Mn`REG}(M3HZpW_BDGuXXF>?_Qja(LG}YmpW&?1lB7P`Fl9*Bi9y- zrS6bnZalO@qY1CtP0|KvBXuW!cCT{ma(&nqh$tQ>P|_pmesxMriFpZ!^VG^@Yy%}{ z2D;bzy6ZWf}0m8RA9Mofiv-2I%PP4?e8!xwi-5MmaQtu8QHX!$Dzor{JX zV?9-eja=a+`6>RBy+bi3yL8`NvXX_mg$CO?+M|YxW9q3FJ|K-o?8-_Ps4Lh?3R#0a zI`cajaCNnBa!5LMZrmauQqP0zZ3l#U#lcdt961Bl?+YijB93t6I4ul*OfCtXbk?cI zhvwZ9(v|>DQ_%ip6Gr2ltiObh>x&^{qg+qEB&`1`cq)~#bb4ITTAZv0@;jRy+rU4`7@qM|z~{nRXCe!1O`7=u9^8aF*9nLYOfZ~4rA_#j-XK@agpTUZ z`G}=uDte1gO}znd;xv^u3OBsdU4UENEO^LfWNmwfV?qymVjHt)r|%_F6b1)&trg>m z{fYQ#eQ(>vw%(De1E_HuOpW5JH~TUE+;;0*+P`kARI(|pljFLBJkhdz=e|yLVOGNk zF()}^lityhU)p1Sv+s=dQ>+HV&Fk%MV#8N>Mht8)=AuxPbWRep|3S7(Yo~Rt`>9Y8 z7ht|<@sHq~;}mK319kHq%O_Uchm>Yws+Uf5 zg&s}4WTmxN8`!E_D-C#lu7E$ODUu0kHO)2Ld`ca0aBy%Eb5&x{i!9-ZA^=M|zL|h7 z?5b!NrZDko7pM)-*10SD*1dXnw>bRX8CQRD!J10es;Ess?a0}IbK&jjrnnx)Xx>}j zZ``x(`?&mw#B(-%rDIz}Gz61@K1VJp5jn~BmVUEingW2TRcTsE7Gj)21Qg+F)3n7J^Z< YWFQY=uR`O`1Tg2L?Aa(x_I&&4A5i=15dZ)H literal 46268 zcmb4q1y~))vhcy3;O_3h-QE4*65KU-2rj|h-QnQwkPzJ61HmnXpaBBpKVdhM#=^ba;qNNF^u;bO0ne1Qa^N&wcsgYLzKnTry09wd003eR} z3IGAG6aauG=LY9j=bOS8Y`t3$Gi2ZvUY9s{vF{1=kr$%16wtog+GW8yJ5A z*sm_`|04Lk0wx1D@n;HiRWRtMuXI}vH3{4$8KwQKdW)Zj`5UT<0>BMu^1=XADYWOi zcorUt{V0E+_}C-Mc#?DdEdFn5002g_SmP-Qs&7f5VZatT z%xswqCTRu$U>OW$CF6KOg^X3sNY*|kq z6ei%*yrynI$(Qq@m@-w{x>2eCZ1wqHGJz?;V_^>VF>d-E$W2Ap2+#=8E~5Q?ch3Zn zAQzfZat}Cly5>LDQ9S~36e5R!4on6&f#$DSwR(FGyK~XG2UqtuXCy_ybANotA6kU5 zE+MFxhXjFT24i0cz4q5bcDxxg+)H1mIC&4o{R5s?cGqe@(zIlLS0+te^SKjwu+d4X z>Fl&)>Ql$G;p+=3qJOY}*WnM_0VV#D^jGKBK@GkBJ@re^?CGb2Yec*Ym$(1M^p_3& zf!{i)l3_#~%92mX16}9E@bsuiPh9*`rzB`Th2GCtQPR3bA8=3Q51#UF{?!d8dtM~~UPTGE zs-c|fpKJiL`JaHoQ62Tgvx2#T!^eB3mJxjkN_`e(+FIkb&wr9ZHi;8}>rx~|^?J{) z_a`7iqu96V-7ndA8&AlbC}q_5?=Y|SexHjS$qV|6=GiI$ux{4*e`3H_xZv!9!|O4@ z+GTBO_wx5u?JqH!&Fv{qhTo!*Q}9`{O%VY#EdCr` zE=cOYtK1L(HmmD^-)gWtQ2OPgQ%}Ng#_V|1j5z5_jiUmGAVKi-&nWm< zZlWij>+jVOG44o%lRGc@lp~4){{o1rd>CL? z!%zU*f!r$qAc8so07;b!o+1%E{a+}k2xlU6GQBtlleRjMelJVg;w`jdVZJ$Lc+ExH}?N>`F~$r@SIZzgDvqtPAzP zS_$S@V2*x#a~E2+{yJ}PWEw2VAMyTAk-#oO@{}NOzb6x1wsqN5Jeny|8R^8h>34bA zD@8o%uF^Ks{1cG2V&^wa=joSIN~v5PoF_B4`sFnbDAwJJAL+$A50T~#RM+s{VzrM` zMo;a(q8IXfGq$QX68$nbxc&>Or8^o%O7I+vkGL6q`(ZP4gLUh&!t!R!ZU@sIiaT2m z>v4##Q(Qa6N{2_mQek|meE$b0I5Ne`U?xa0!T4f8SLm@6gZ2LmFg`+qp2oGUhc5W; zIk_gr&G)#i2daw+CtN-bZxdUzFCt^CXcuw)4FZ0VKNrug2a%RIaQH9t1#9E;0iD~A z1JdyJ!XrvsL-u5qR{z+ytwy{@UcyC1%VQq3e=$E-z)QqYsM+?H3u2cqsT-2ZTpeA0 z`Wk*mqTIQOzkPK4A+ftldHf%Y0Kjv`LOzV+QvH|vVR`Yt!HSH$&Wp>gx}HPpKEvo0 zOe@X#8uxv3_J3F_cwUOw;s5~PIVfWB5>)&UytW;=w69*QfXy<$OiZXsJNf?aQ5P%# zP(e+Ket#Z$K9erLnMD2gP1kkRVCSieoNS6o(D>pb@e6d%P^6U?y}xVeFTt@3!6MIJ z69CA?NM1P6H~R}&oPjP#-VpT}PA%5=a?~xpdAK~?Tq666RMq4l!GRUObxKcVlkD%F-)a!Ug#-}t)L>`*rHkKs z{;q;8Ci)?jS&FU>`*P763F0{&|3?7N2ti`8R|Udp5Ipu)s9^YyQ~*Xv@_ca5zf$CX zp!t;!0LX_kqW_^2jQS(X{E;>OBgG$Ev_CQ)IAEpxB7!gcm0iKv32ZZ9024h+yIh<& zRKEM?X0H|;sD5n(A$!2l3KA^~Y@~Ouz`;x09vm{qrU6)mnvr}MW$|F61p`Czzitwg zKojtcfTKv3{Uh^Hj(Wdh0%OSK?|hzn0NTSBpMOBXV z@(JAI&yl@Muq8uKM@!{T%zq~Q9{|}S6JIPVKrDM9dYxEI&V=+FlKvB*%BTY1C@Y?$ z>c8Lxc#q7427rWwfP#dD0ziUy#9)Aifr14%?XajT+XilXCUP`_daZ<^u3 zJ8B3R$SbW_JJ~kV%dnTczZK_X;SCBOakJUH|0=w`NGz6YMNQ&${ay^2k~F_WHgX;~ z_`Tpk`v&tn)i0*OZ4yA&Zv*}s+RH0EQu}w-Un9wr-xL4akj?|U1oALH0VR4jXS&OJ zE7aF(p;hN^U-vDl8MTwrUm0c|z7g{KSkr9l{7PbhoRHEe5VEBEBOTGtQqbZQ!P|>1xBv;!cO%sqY zjkzwsoeh3^%N*vNum6`S{#MH0wO{JFP#~2njIdXz7EZBS>q_%ERMd#}p{8ZABxG-=slJ-bo1tc0y@d0re?oqGJP~}3 z=*Gb3l=O1nqudkrj2vWolUm`n1S+(HSe2GUrK6EIPLmQ7G?&tZ@J`q;T9}|e{uUXl z#C~{B__9@?7XFE{6ZM2H1^fr|3HLsTrPvucms(1ktf~&d6 z?*56XhRlWha{1o75rw9^iOMQd%`q}c2wli8)o(m=btv*^^bn#zC>@1m$ci))S2)Iw zQ#TjBjrt!!dzKr-mFF6_4OtK&$xS!v=4YP*Y9*vsuQPwBMXi&JUFi!mKg$nX#KUX4 z(CY4-&Jm?nFsY6*!)caFEPbzn({~cJf;{j4wc&?nviz{<=WDKD+ZdhcK4yKbQgT{6 z1h*0-Q4B@`Yll3Xi-e23mv|@^dIvuEq<6K&hMayGK{fJg8l}zqz%}PHjGq8Iu6sR% z|Nl}Mx|)SvDBwhFN60dq3M)|ZX%rip)3pjw%*+~3*sXQTeSTM7?e3jkRHa}hKHKgc zlhA7*GwPc-G;5tqB0+h+T^~iVQ=~a;S0vumpTs#!$4*RJbwvJ+pCX{I->_x4uMTK* zC=_pkhv=^YO7$eBj+7|=L#b*uA;M%@qMeLJpB^wjpsN|+zH0y^_oZ&jM4U+2cgI(U z-6slb9D%iTYZXLMsP_)~b~UUbH!7P->m(7|t}OlKI|Kxdqv1Q15@Xp8>z{yx!uoYM zxbRP0Cl*`Q)F++8TT~Q6?Kb$@@90*K?)gk-1l8za49lhjUP&>Mu|PI7pKeZisjIO z#SI@FNZgTobvocnJHA_Em=z%L#ZjVKQleFW^87j4d!ND3)A zy)B*)EM}n9xM513{o8Xc73|8i;U7@Vk0BVexax<+D$A4<*1T-(P(kIFi%ATklkYo3 z(AJTu`DgV*SAF$<0$9bi8QvD!QJlcaywc_t6O@uVM8C)rJPpLE0FNxjik%Fsb-aA1 zDTB1%s8EBrncYwbZ7dXI=p1-JRURBSWm*~_;i46d#!-P5z!~Pi_Rg)yAhM&LAL}i> z1e5Pz4^|6eZcrawbL{KoqW@8y~X_wj#_hEzCfuKh;pH2?)W!&H--CEd)zm3vb&`T<&#@}3yOLsfJ% zkgWp|cENI@vn#cNbCyYl*UI}q9YG4G+w)is!!N;qn}xI}1nSDuS%cT2$nlK(>*enS z*63+rcW2jHCz$_V#o%nGR_*UJzgP(6Pxbzd5X@r1*!=PI-}SUZZ&*Y6KL$WfSq}Lh zn%Yh5j4A!6mcbfCR=^|n!5Ap?3Nm6?t~B~|5Xp=twcjXJ?+oR9`ltm^+FM4X_#fWr>{>%{9X2 zS(?XjefUy3+IQvkk8$dKn5$PwwT2bSL0?;z->1J(eCHFl{qQL4J1*p2iZ z**l%CV&Agig*jRNZhrSM1h;9_kPd4&X{S|slCGuXIdBR;3>&Qq79sB6s+D~iWL+J; zoo~fg*R`_7(8!g-aDUo?i?jMBVx6ogRg3xC5y6BCBjXpgCAy$|+H=SNskA%UJ7ooy zcNAD{r~%Vv!Za0nDhtC_>}bi=FAn9k!mmPP2xJY&^{-O)tPm07fjTGe2H3l|=HF#EeJe94D+LAR2&!3!aU+P?&B9aQygW^9$n`c= zN9#mAF6%x!j(aVoH`aanyVA1L8tO(#F(} zomEN~OOHJ69o+XvdQ$qKbA{s3FY**oQ^rovYWMc`Q9yYPaz*r{Z;Om4uKKT7c098>JSt?0Hg=xjPXN6r! z{doEemMHo$JNdf?FX_bFsG1BQaJyN@jTu*T1wQ^o?bqQuWnI*GaWxD+l2CiI9nv$4 zquMGpX*ZATocVKeYK4lQfLw6W@s$~MDM7$2N&qfu^&&H?zRW42OAcOKfL48BMyTca zD)Z!h2E8}f7JDf7M3UUFYiQY3kUjXW6}v-{>JlXHSLU!JnurmY{DsTR}am8to)vJHo*x)9=uYGW^K)Wos?}`kFQZz(NDk|7xF3? zea!TOOab8vA377FligXC0+cHBjvNK+)DP>0R<02_qcom$8Glx(>a0Uw{yS2~u+J5B z4^tpn@v9m~yX54*s%)QvB}d-;8xq_<6uZUB@*l{%gCz^U|2@^8vqtCiiFN-&h+jSC zEhxl>f71LWWPDahO44XwB^1Ik?d&9KvkrBTZ8Qu@<&$iH!RHl~>nautCB!~jCSzUw zN0jvHhD7_^ss^_(x@sX>&6EuLZnKd^y1C^s0=F+EW<}E;I4yFb#~*@gb%%Zeu$#Ml z{hBDoO6~(zu8vM@Fs$9G4d*JSfHy@=6@i)sZW0JW{EwLXGW57f^Jrc7k2P8H)vrS> zwE7c_Yq`CukILqO?be?>o&CDCN(fM3^2h7eZ~|kaA1&~zzRHqz)kV<{GX-L3zN%m> z9#hTc1v>0d(`k@!_e91R>!IP8Vm6!2D_NJFUO^<}7X>Wp0_YPkI|5d>k$wWeM`p69 ziA82&i{ZiUH9ab$?#?<3q_$yiqom7UbzIq?T%@L93N`FjT;{KAoTy?;zcqPV; zq^21_f&9X5>S^YpFQeF-LEoxDhtQzJ5cXK^avoui5=kgG$0P6N@qna4ZTWu4(#`8b z9Lmk+dUl0eWw~u+)tF>IVgFCS3;Lu7Du2!>(;VGN@%tm|bdBiZbj0pfDmsW>$nR{$ zm8fkgf=waT?O${GeYwvcvM5N(QZy~?^Xcc)F=$}QYDPKySWlSmrP6qGjf(5q$r$^M zmMHTuJgA(alNig!*XiGWTSvE(FAJpg58OoES126M8qqByjtS?1d%gRTn*&xQ%v*K= z*7Q^W91rKA9{tacufnvY#R9;{T{}9JCaomuSqA~CtE@!7! zkjT<|!O~Wyim`*2@U8b0+YQ%|hxr^t7NK;Zz-E_9`ein=t&5Z$yUH$e$BxEIc?6nS z!q#5&59*rQ8q+d{uf=45{CvQsH3yp44t`^^aNAZ5WfKmS{VNEOlA8;{SNLleBD%^r zpPhWk-|ufGG^cB^2CS*jlR0Bavp)>DL6^zu+s4R|p_Sja8WU-<$!Mr=eu_|c7oGN4 zXiniFad`w3yL9AfR{aD7)gGj8@Br3o8y(KIrPM^v%+zxjzSEQjKWL=Q;Sdq5p;b#i zVVEk7ItWDV2#!`ZO0QtmQV+1_FepYW)N?F~V7(Eh#gGh#O=PlKPt9=&4JS~OBZ@MO zZHO#c>bZq6tli!d@?U#J0Z(Q2z$K@sp##dd!JgXQ2cVhXo=&+*GxnS*B#3WO$ezKk zz7!1hs-sN!s;rwaBOvP9H7RZ>9-^NI>AC-+Nh*wkU_H=nqj-+mN8PP9W9NN;qU@@N z+*Wi@LrcobX{@S?3=BBvsc6!R>iD=2k=^F;-dAm`j>MHK~bu|!hU}1Zk%GFGL30#13p?cX9IwtXiqGcYk3OjehnSgxM1dyRKphFBC6KCI`noj1$hPg@TP z&)Q?`<>sc{2@3rBV@$|dyf(gJ7<{iN|az6NU){+Ia34o!sPLDBl zaH;I(uPX^*YUxC``;j1F@MLgXUdAeOGJSQwiF$9Ko^qeUuCLcBaC?P&naA{U7PeBY zjH5)M6p&}3b@KWmus4?dOHS89%|v(~DJFsdx}%>T$7h~Fpp<+^^B!NOs7{@prlXak zhCex>bWuoG=En0^Md#|FcejKt!cb1GYI%Fj?;N}vVH}GRrgDZxcMkBzA1TTw2n+>=m4nRn zjxIzN`2_W`Mn*_&nzTX-%-pHoQ3hF>iX{7fvtGV(Oj?A;7HYC#kc3{&HQ$h`t{*g0 zNk_{(uz^I&7mBlr%F5xO?DIW9bfK#s5MWuTl;W44Qg~YS$vL*LehWie9_P|V;ZMaRlTd+*TJ!V;CoJ z4_k)Dn%qw4>Z{w(*3oCm+di)WBROrAG@8v86`;JL z*Ue?Ra!1!LbJ$!ei+ro|Oy$@2bw^=;xtAH$#EShqM|%0kKEzgves=-V&}u?Ww&Xpm z*p|?e?`ie3s0lkf!Mz;(4tVkn1d(o~B`F0TMv*6aGy7D~&j*1iGnQN@r55Ita&sUW zvjRer@9{l!a~b=S?P(~`R194Clqy~Z))*~?`Kv(TWL-sb{T8w4F3U2;!(ROacwL&bEUqFuwCXF9jJn=O&SeX!rm!k*?0e4a z5xr6S6zlxxA!bxYTve*77t!I%%Ld}|S`KoW#8eOkHH2lW69|^e;e1mu&{DHBiV-+& zinDzIaSQXEz^QWRdhpF*iEg>ZovE1Eg8=$YchSzcBr;#BCDs(8)#_PRz)OlJ%&kC0 zkQ??sO55^IyGXmr_2BE2_C!HKuVJmhp8$>RmpvFwwJRU#fZ{*6rAxe!viawtnOctJ zWk0X2^E=61B3iClqlt50ybFewJs9-&2>)a5!UiZzL>F2H5|KsqQF;@a44m^J+)D^XOW62vS(;y_GeX+ zNM0p~z0jD5`3XRFxpH>x%IswED`PIBelH400Vl}-wU%AQ4KMWYiy7k-_2?Okpq1%F z>CdMWs~!=;7@h-`S_{;s^eYvpFfwlfX9?~ z0wOvp4wz-d{gdZUIj7-z`l$3}&{*jr$Q%+t^&ET764ZcffmHJqUL|gG%`zMwLfZ1R zr|K3$GtS{9G0jr-rlWORJq)wqa&Hy3NCt9!kdcJTgKfmcNADb1DaBM9apDS023)8| zt?lWg9U;54!)tGaL;pH8;@uFsh&z<_DB_3JAI;4bKo+`uJOZitmwxA8&$peTLEUlc z%^b9Q&aHweRZXovsKzV2^xUDaHEdS8O9Q^oI}f ziGVbF)z*5RTA2e?u59nPSZtPQNBih^g-Qs)K1l?DJdP0_5r`WNposK=opM9c-0@B+ zgKb{b>*jJ@wUcX;xl{KgQeBq?Y|N3~J!SLuC`F&q6><^%nD@srt53#>yTei}77Xs< z@*#beo8-GnEz72jj1HOMP%5ayC}R3S83+#$+6xYCSte)d4rJUn%~vX({@7SKwO`zZ zHn^^?6z9yxUn(V+gk)8^!nD8+4N^Khl2=sBD0b`vykyDZ-BG{L9a2Ca2MPp-pV*Rq zwGr2_gN_wR59$@Zq2F#6uGQ7ja}XY$)#MR`eEIhCt@3hZbxFZk&zCVn_3KZzYwzfB z(%D3cGk6u~l<93@7`tmNQ?67KA|HM%+Ds5LB3LxK!qM*XyKrwX-*l#H2?wp!(u;o6 zRM}tA()sG3PQS)BA`Er^=>7R#BxSLr-@+Y6nKBsnqQUz?U1kbp=2#=pks9prITFr1 z(iQD^ML#m|gRM12_00VM7{1pGW<#A#ciYvQa$&Z|6@>F4%S!QLYpxl>RD^^M_CA;6 zn#}vtA+`C42<*tE?x_4xYtcf+#_B3gswGfuNuh z14@injvhdGdLh3W{;f<;5U?Nwnlm zxE|ejI{C^?7Sxujm7Q3^BRCxe!!Yo@;FAr=pPn+}UPqb)e_4FfQD^L9&js@V_pd@L7O#7@Mk9h^e*%0E`-#bD z7MlZzjCgLdEo!rCO0X3p)UEsq`Mq{Ht|D7Gt=Yd&i;VGHw%^~r2~;@Tu+UaHK`C69 z3-axKGtiRFmbNh8re{$o%j(dY7d}KB?7&xA@QQ{;1L@XNQEts;+aY9WU$+uPZ8wIV zxwWGzM+`l3O z+7|;#8rQKN%}5MFepUQ$0-x|Egp3yjM8dbQ z84ZC?+sbt>Ly9RrBF_scR@*ZbU$K3KQsTY;=s;DT3v;d!Z|N3uQ_F5vOuC%qK4hLh zTB3G^jK+x4Vq!3>x&K-??B)C$Lomd2b_L8wlzt*%+Xv?Sdzx;YO=& z&pHY=s2+-T5dN&Lrm5YzJV&cuuaUYi%T4T! zmMEK>{{iPh*w;*5rpfH&{xnX~wqhouNarR|l!mEd`yt9}{B<{YfTWR;cG_LUp{*o^dTU$dcg5y^E#DIf!G$q?qJ?QgZKRztaLz*OGo zZk2r?13R#!{Xz7D+Pcm$4fv&Uq%vnr&kzHNH@!p@6|Iecx7VB4=86IAsu7U~z)t}9 z0gv>r2RzVF(6DgOa0t&Y*Z+RNgDIv4OJU-I#V-CTumDX}J)wT)8@8$I2OLT&j>N)Q zQ3>aOp!|lut@B^ccp(3H#uJBY8L06p46vsO-UUws?D4c;fXFT1LTiPpwacM`BGZ5 z;XA*w^6&Kc83pd3w3z{U=HgQ{QCwJnfIj}BZc<^kr7q*DQb~iO$MxHy9aogktE@Z9 zTtt!y6q1+3zTLy>;)5v;VTTzGdSL{oq{UQh*$pHrt7tfUx2Qp@4n0*G7TCZq?HbY% z;);?HtG+bQu3gJ+i!pjMPrI##z|`aNLS6YTzPn&EqGD2{t^0490J;CUNzUw7`e!?Sue#n?73xf>I!(BMJVERpnp$2=9&x1n2^mdn?E!J;EtRS-C&s>z{Fv6D9u*%je* zCu`fBMbuPEr*D=|>-S*>g&kZ5g(oIzhjkS5wt3yl@N^yKlM{y5jztc& zOm1er=UweEjM#F-_(H;_Z+K6M`j~Nz*s{MRaz(9J^_EfPf0Wj9kk(9ir=#jplFVc; z79{*d(<7|3Az*GFL4NVY_XMv^>-uw|YD{0DcxJbajFdJ8^dCKSP4|tn%qMc!&TA2F zwqoCD!Z|C3K{%yY8kMD+F7=yR(UE1;4lEp*+{M@#3PJY#GP@~0>xC}q7D&YvN&<-6 zClGSWLU1dzQQ7tmM$3{v01#O^oHD-^|C4AygC-Sj*DgBpn>HoPz1e&K|oC^a|}5DLHWaMlPlXRCn|#^R}r^tRde|X8yG31 z5%t;%4wu)Y+fmBdnzOyq2Z#kQv_sb}J74)^RYOf$2(9Mv6a=ZyE9Uie_LE5P@cYU^ z3EEoAzLLa7sxNZdgTHU$kBq>uRgTS|(@piQInD=HB7+s)L@qGBzV8^E;7 ze;uW~omd`)m#t=%k*c*8tr5c9?5g@LxSsG9e9S7DJl3BbDk>rA33f*ygqKZta~qA^ zO5w(&W=WF2V!FF&N0k?(DYMQdm85OSoMxjx4-xbJL7Bm3qcB)ADB_2>2obf7;jGoV zl?_znHdSBU0*C#55z2W*WQzPn7Q?3eyF5XG%teA@&&r&oz8H??=*_#FiQ=udB?Z;g z&3lK8?DBJ;y1%}Xy9FKKziG#eet8orp5=xC6G7r3cOW>(fk>cdwOm?Mp)l$;(1P(w z4#t?otmNB))$3Gu7y2)J#i1(k*F8oqU)iVAU{j*W5$tV5KY-1_v@}OXK7*u|iOV>> z14_(RLfoPJ!>!w``=EZ#e!Fz>96f_r7v1Yyv1Ru-WJ|t}DTq=^3Uu{n&?p?whc%m%%D$hkTzP?1?1Pi4^T`?Lb zOD%=UWYn!97sDZp!*?(vP`Yn1kq=Vza`Vb5x|4I_A_TVl69J7Z8R2D@qJ9Ei)hV^1 zj~43(! zL5m;M{03vBj4FKSaNC$Y*ekojhjuJgHnaXdFV=IsMy-!u7njczy7jN4JWMh+bab_< zlu#;H*Pw35U}L#+zT4JpQOzwz6ZS$x#K?1AlAImUHlS`Q;0LrI$*S|3>k|+a=|x#5 zXR9}>uf|9?;w)`Bz27>h%(GLNN-4M3l#AWikGo}K-WAsewVgE>{p#Flg8t}vq^-ju6a=#Nc%x1HmyfbHmG zn~g$mI2>H8(#&p8X>$<$-rO`VB2~Bq>yI!_r(F`x13mlFZ0~>+ADmB= zSsT_W=qVFg+fX^fC7DcGR43wv!;F=oGytxUBZ%vQJiZp0x}uie4?GTTPA8 z^1bi5WMt%iTXaK-E5CXn?Ps>bYbhy|y5@wQ$-ngc0o^%TpL&B7)^%`Bgii;EEOPRaZNZzlbrU#rLEC}czoF97(TBNDY)ek9o zVim`pAxHG;#&q1h9^j(2U|4fdsL(SAWJQTKeq32|I9F3iL!87Q(k&wzs(I5x_Qr_N zWZuJ@Q@LrCSU-fATE+}#MO2ihjd!e)9cGq$(oDMHfSrmq`;A#z7*YAyBTwWST_KMX4*?3V7DiuEZEbm9HopNjWNywm(vO~Y3FbQjnqA*aiyy4e` zu#_P+1)*)|bm;fTW+rhGH8tcNG|3gLvaoPNCS7OtntK_kK%Gy7eOkMs3FGg(;$Mb( z2ylqbZ?6HIHni{AWD?mjH7bDE6_!8HXvpw8!bMQ^ci8er4v%%pEGyq}p;%Cw*adOH zkkSWH@R_VCPqITMsUJT8R4&E+i7duOf^C&8`%=Bpidtpo^A38$I3htjy^VXx7ERYQ zR*u?`FHcFz5GODCV!!H43(JYzzu1c|mmdcocs&>m%g5Ex)i37ZC<roYm601>JMilMW_&U&5nB;)tPNl z^Y6-Yr;<9RosI3yG)5gmiOECE>eV~(ahHBNV+~JJ1T-7tpr({5cM45-HZR1$X*Alc z7<@Z-7etppfpmtitES8%c@(i{Qpec9_aPMC z1|wOM)$NjATkDe@1@rTQM=THoAyk(?*ygwFG$I*w6Pv+>=ckTxdV<<3 zy~qr^%$WxcC*z#<2ewQ~3XiBz@zL9sGkTeAGc^p~fUb*ZRgWm1!qO`maWrA@k@%c# z%k4DW?l`xC%T{;W9cPcIC>5ufx3D>bmWbv+D?!AlU42d(r;56tnSa(H#MT1}fsr;* zGA|W-1$jc&(BYLl+A^)2W)?!0?A=3ss``y*_)z&gjUg3(X;EA;Ex8u%@c~3dp^q-! zOx!uL#amwMGE=OY(8G8p3VebS){h`eid?loABL zK&JS`UgR4`%bG>TgrBy;;nne6{W4*{Usv^{ab-CuRv=VuKIwKxmPVxwl{Yo4B%6Gf z*Mt_|52&3<7pXZexelMVL_cKh%C*-N(srQ`D6XDFLt*~K&k%X%=D?~VQ$g1OwmC~7 z052x4SxC|5A#40No#mdt%~yg}sY~)Tz>DaQ*U!qF5erl6{O4{=Q7GrBH|Z9K5}cgn zi#*OTvrag{bE|tTC>nbMomHdzrgH+P!&mo^7+HZ|dC^UN0$!1V56#MG;IASepkZJT zk--1R2?_P<&wT4%ahB|b5 z`6S$G{kMiS#(FO;9BJ$t2*FW^LH)%=b*s}0brHlhk8jtM-~K-hVSUft?H%-WcXFkn z5^=dFV9V*&vCNjf;|58wANGH1==rvsjSLJ@wjGOS#mR>xJybfZeVmW$Yx&eAB>TYl z-x>`>jt|+I=B!J6ZTG3is{XTw|F`LNQF;878QAgcve(}#xYLOoxiS3L8~%r0JX*3Y zTof~4N*3DgP%xv$_B+&>|3UEI8Z)Ly7alRoUptgzg=|x};qHwW9sV27KSZ1 zODhuGQaG|#Em49{q$BnH&g0u)d`$H9a+_P7$WI`KsuCzKdk;xy58lq1Y-dNpcmHe=7JkAiHc!f7hZZkJoF#bc+C zLBmefHAD-tR!$J(1O+UG3%0KK=&+NUER->48!;hjuT{!B+DsM`z?9gl8G5%{>pgdd zQ)IfX3{076!7#S-UPb!=3s6F-BJ-)r_jU&D_M2k3v)jyjLfUXAMHR;IEqby}aT5*8 z6I|J+9c0k^lhPqO!>WeseK6a;%@JVH6_eEe1i-De`X`J$eDVC_K5yYWWCm_Gb{{*abesBoKf?RWpL~gEh zZT;Ga>wEN0v6&2;jw%EywcE?CR%rEfq+P|Ecls-lsjHZ`+Si5VEBvcNL=*T4)ez7EaOOjVf@xybzuFFLm9qm#|TO*sLe@@VI+02&fp>2|!St&m#eO4HS;}g)RhPiI!N){siE3WV_h94D{Q` z>&3|N!g@IBbkDX;jq$jW9bwc5zu=lq&ITRJ_WOYbD~(YVJv7rJF-lq^#B?}cRwIdf z#yUm@YjwIh8guM8MKc<*)+8m^xcPg+CLJG_)OeD2GH^=1Ygq5g&-SsJ4k6c{;!#km z1om2+QAgdIe>EgeZ=mSrsJ)j-=3o2 zQlCv7pNd95HyvVlvLGZ&TDqtKe@>fpxBQi~IVsnPXt?)dkETmw5I>PJ)U|hic83F{ zI9pdqQ!TY!i+ST!OCmzn#`Zpj8-YK~oA za>ST_Hlxq)t-tqsf25ZRu#!ytO?!<|1A+2){4Nk(?lfT~!Znp5!pK@#xvCNtZ?}O@ zB5S~Qp+~|Lo>~G?`S(It!)KRg4Q9P;rMV(N`GsELIHANQI%Y&{M7iO(y3C8=ymH53 z#e7gvmmaow4)AGFFax@yK#G40^zIhv${kRNZh;6v!mK5a79T>TN=-?|G;ZnC`2o2h zU==eoSd^XgNEer%Ge+70L0)UNjtR{cSM9nU*+@XjQCxG|Y)rFho@&0r!d7goo9g%& zXOA~~Xw)0Xn97VAH4}c`RJv25R4Umt285JC)WS(d?wppcX|(CU=B?4Dc1&v$0MN_l}RKV zjRh2x8Topj_*#i$a%=_;F>RCiK=XJ?w7*b^Yj4rV{w!7DQ6lF9f%NP?jF~dI9!Zw0 ztLBo)rb9=gRDnE;#YS#$Wc%%xwWS$FZuKn%hEhkWeH1~juD%f;f%3N{wqU1xk@p4X zm-pO?gykGlZZtV+t$npQH<=D_*C>w7lG}~x*$75uW`#2JK{&i+aiX-kKr*E2s$ibv zH4=+HE_Jd@}M(^rl?AT5Ibx5pg2G|(%i0oxcODVN0YWpdRdcnG!UUESf(T*VYhqw*O3|d7#UK~fd z+QEJj_+W3K)0Gj>Ve)o}4amzHwn(?;r3osabrn91iaAQ%W8Has-6eX6H&S|P2vs=M zr|4G7u_fn%Fq$8!F%y3XfB?AOp=9t~1X?L&LF=i4@4?mGEN{OR>~in5|E%!X>& z-`qem^5w(})a3e&Bm#1gsq?ElEvxHDXYnQ2m$JtnjJial8%2;B)&sF!@7z*s=11j^ zsaV3gXD>}}JFdR%zQjbb!RlkwquQHgl<1gJ>Rg_dNG)t)BhRF^nL-iNX(i=#6^Kj^ z+xZ~gKbSZkX*a{fkQ>*qNEi&`u#{P%q(kKe{_1axa>(pEAD-KbG{z}2L-3?9!wG~0 z>mN!WY~ej$yon*3aXV>hDQ+oSO@=gZ7{by>6RqW$Pty61J7O{5g;ry&*2`OFPmUi#UY+C&s(TPp)YSY7 zxkVE{0Y3~?B)wbt_%)LY^$m6_&q&dZtL>>I-eM4l=)!5M9SRv+{A+{x>0-pc{Pm$! zYnDQFj9<5$;<*a=d(}lLmqMcT4Cuq9BP??3wK#IW~@nETEX=#$r|9B+9 zOE{{Ju<{^&Ps8A@u)S=YzH-3Ij6o-Mn@Gd`4HZM44kJ+TC&2vAnNoM*E7Qh`E0s&t zwbjVoxb7Kt?8q@k*+@P5%3?@VuQERWmT0X=ItvM%h}1`p-(vQZU|iiO1mXIPF_SK=F7?AeGpTZJ1+4jt@~@Q z(#r3sQZk0auYK!r<$tG@<5P7&W-?UrGCgrcW@72&au_y;@F#%KI3WpEk}QJGkffl7 zM(sL~OAE;NXfkK>-)#Q>QT7$!Q7p^C8}|^~xa-C}#E84QyDP*ELfqYjgy_cIh&ypt zh&wTeD4!nh410Q-&;wUr5L{p`55Kj6{3|iXvyOkl@jx?NrKZ!PzrAF=Dqw?Xnbvj?wW? zbu1b0To;2Y`J|}ZG^t;ZxJ`06q+ft-NYtEz_vb3w`^rZ2Sn(spWZ*OPgB$sIBujtl1p`F3RovpD;`70pZNKgc6p^_rhZzC0iRHx zCJov9CMnl~elF4N3&7y=_lvaEP=G1Ld+@-)zwa=E$~vi&g$)-qMCSe5T5pCaV;nOwCdxwoiYJX(dnZ zUEd4v?4@gX&GYp`WOJEHiUcK!m(%E=3-QqTsdz$^$i5NjOTvSd z-&&31Fnr&dBY7M(#l)j(0s7Q~eA89&!P$(elV?$XbTmGCS~%%AK~&&#rm4%6$i9>mRjFcfGV-#YVER)v$}rOEoK;nbpMnl-<6=RwPIC62+a4 zCOXu_?~TCI?|^v5WC>$#j#MS6g!hrf=nv~!<4seMXSVJ0beQ^~9U7~%Q;rOp`*U87 zTs6twmzmu! zjY}__X>E)xXO#AqFoKHEF_z7ppIu-gw(M{HIM+ZJwDSDd_yTRf$HK#+MFF*WA4Ssz z2lubmdOwt?oBV-S?xT)QwUn0UD9vNu#Ku^vW=vWx-_^;n8`RYgmFn`H`b9d|Cu3Q|KTQL94eva^hQsUMBM`%ROT`=(p-_%dA&eZ6M%yTxKi8&n`A5xNEg zBzd887CAdP!*uLfY~l{aVde+!NOdf<8O0uw*{bZSI+kMy^A0?2eswL{xi_da2m6J+ zkp2!xv0W@1_0fMWIBV}{+7!U3);jdTql zeVmhOrwG-!s45gdlT#U}Yt@z$x{+)OS^t1H&@|Qd75a8z3D3{Om~dI_>eQjANeXHQZSxA(dw`)-oEnFh$hR22MEp*XstB$L>zIv-EW>#qkYJpF9?m-pS<3I(RKfqx zU`u>1&lmmYbx=yqNO-jLOo!VtP`I_fC}F+YJ>q0qQ*n#oY4YD;1mmbF->*+GExWMd z%XU|YI`(L>;)Q$%B-gtX8lz6?!Lf~o7Go=a&Gyh|9%_AK>3d<@rh)Zp$)3OPnJ346 zsAS1=a_z?hm}#po2jc^=v+{CjbYec}z7N2?Z_K}`n7kd)ys$MvL$9qUD}3Y7H}MQx zqK}1Z8IuxMWS|iA_S?hcVDnR&edo2rRW`wGkxH&Hl_mYe0?FxC=tAZ>+9;$sZ9})C z`dEYgpaRw2#va5xD(AlKZ+`d6C;UQ+Bj&bl9eX7FjCx-h&+@0Ycc$H%xwpzYZj6Y9 z>~uf9NrOx656hGTV%l?wM@n^ozINdLtDXPBs11BsO(!psIl`P=XtH=iY&R?ayNpxF z7=3=jC&1{5K&kUSSnKWoQWyS#VFqXF>K7LetuN>jwNZ$bg8yD6{;9Bqc{{G{(Pi3Y zMVNOvgQ`Ox%l}sQ{vo};T0|H9e7R#xnQNX8Yw-1!sxjJw)?dN@kl^1;(tz9IxK^cc zX4f9^YWOx)AR-(U?Gbgq{F9>`CodX{G5{zc=OvhrVNi_ z?}I2;|5l)+gEqYN^-4Py0OYh;t?eUEMdm*{xOUhA&E~q+u(uRz3cHbP9$Fmfh;|t%$ zJ77}kqcTNqI(H|@3osm_vZIAeGqkNBD^EsX=mX*+za9!>#cw`0+j$}WVVQ^H~ zB#&;r|IEPq_Nxlklu9%Q1A*V{I@#yF1au{Vey&Y9Voz-Q#m?LurE-z>jBwlxTiLRd zB#USfb%tGI$-Hk4Sm60hj_9g}jC=xG$r`6Z|C9zU&#vr9!_^xd^`JJUFVslU$ocwka2D-j?Vf z%?sb!&%Icpl6(|>nR^i%KP{qRRhU$va(kS6wLcfyn93(MAuLm`G7D7M)Z`^p$0u?K zp32;uuV!@dtd>9-n!Ra|CSFSjQ(a?BiyTTk`K(bO35Ub80I;2pda`Mwr#nNt1@R|1 zedvSu6JU#5+J2ign7vF~mnT20s^20y{-fh`$_Y>H%5wTj6YUV-mUGv9*bu%LW%eZl zU$eW>l|H`mmGv3n@z`^NnN_#o+@}+;Ng@m!_1dnS-c(@Yc7Axr+_*tQm;E}LdhfCa z|1Z>x@-c7>is(9B4lHazM>n)x( zym@Q5QYzXHZYr6YZd_CWxknEVMR6H-YPZRRE?@dPzvilEmDB&+yyP^W0;T#1ep0~A z2uaS+;a$XWDwa}3n93w0Pgs5idccHRb8Yx-K!ewpUeoJ>Vi;L(C@+MZex?v`tVCht z>wTkuGt%2d51xD z6q~s~+!RnkdAa6qjmm*wN=qgE=iU}F%sKaO94|o1Qb8WlTErZYQo;nQdNJFE866g2 z4Hg?>dFTe?oJVV$(Eo_2vQj4QTH81NR zJf=R7KPhUq$wC6+%+FSDqH`h(D51%Vi(p>b|2DS@*Ss~eY=fWNNC@C}fH?YALN(W# zXKJbMj)|O=X~?(k(o&}{3!{uNx5~(<+YcfJ&dg0F z1Mvai$d;WR@h)Duj2ae>r-te}FDzSdjfV6{05iAfmDlGL7veA9G!ciTaA?tym@=r| zU7di_hBgNy;yS0eFrx;Q^BLrGs|7(K_apla)~qjEnkYI&W+-!u2QyY%$Boiczdh9s zV6YXqI4BmaPkV(=Q_9lRj&3VEm#7G0G^jhOGZAkMO`%~lSWKCq&4BELaJ$5$iwz_^ zQ<2pV?D*^|*XkXnEmMy@?~}nVXw040r&k!)v1n}=c|nts8QiLoMWTPS{qFq|^^m1C zQQl@av#z!H7HJes(+tKEJPw%BALaEG@Lddjc&xji&oPl@L&Jx;U}UJv-R9kSxItWJ zdb`*_*@Jl-gIHp(^v$97xi(Y~M}ylfb=B!Zmd|N8ifIeCLS8m>xJ70`HDDs8De2j8h-<%689W*<2AJz&?F0B(UtbG&%cLbLaY16Y*WGeFv z(+oE-ir1!Fx83`*x^bQnUb*QQ-Z+Hqf$3oqo00w1Ix9IQRY!{lErdx5kgrvF3pTrD z`qh;@U#7Y@z99NotQMU3Vc;F#DnWFZVZ%*tO#?tKOYA)&fveQv(M1k0$&-=;mEtif z>#VBn{y246M%)HpEjbdvT(qNl`JwiJOC0E9f6cwVVS58@OpxB({=r zf$w7_w^3nvN0D*l_(E_DNPbiod4?BnLM~ZzLaRRGh$zmI1-CXU0SO5vrUwim-v;yqps$Dl2O%WR*Clbae5$Ioov z0p}>~-vOTGno-9GBp%7gUO{2+A)Avr>qM%t6Vo#Y1yoHn$i!!1>}V^K40N^;)&>{{ zGR!kSRY)CqBaz_%tU1KVOx`Mi;fk>!wH6&O`j~On*NSU~U{d2oFYaDMGgrt6nICjh zar^e}H-Ece%HpsNHM5MOS`cKcSx)l_%(ZN%M4edm&E4&;lI1c$zo+Dm9#pbl^|^at zB#rj7c*U3(qdXfh^kctRP0R!E@r``qSjy_+>!cee{eBJ3$I6d>J=V`J3rC}mG9_uX zfOEU^50oQOL*_;Nv6M?hNI)=S>SG(cIY+8KQKHb~Z%y?EheaCJ$je=xnXJCfVni+y z4;G2Uv7(+{t&!gMJ{(`rf6ii^w>+gkoK@dD(o^gDq-|Kvqpy0isn#+$UbXn<9lt^; zMo)pgEdJF@Hh124z8{gp`B%FN#$j7ZI zq$vFG$rYBok@Xk16_^yM>muB}TVf%vXMYJ6gCW3&Ma!4(i1$2Bp~|+}uLSLIH6_ug zjTNQU-bGKF+1p22Ze9XRV`{GjhyMK4xVdqkN8UBD4+BB`UZ6gTm|TwyoQV!_*lxA6 zCwObRo>H7S1XLC-KPo4wECSHKR&r(D$Y8t;>y3R{JE$Ky@cJDuOpaui#V3w6q{Oc9 zSD@{e#O}=%)<>@Xe3yDxC~1^-Suq4&J2<-&UMi*lsI;4gV9J9G8cK`mY+Hp*VWF<} z4dIY9a1bRfi5_GX!&Wy~r}-knwzkrq3%V!Oin`ey4m$JRA$TG+6{l7u6G-S?>C@MS z@s))pEBO#XsIklk&fUuMN*B*_Oj5>G%9LlArPS|rA@Pm5J1bTKak$iE zc*5tb=K54c_GN-z5&$Jz{5If>6ie=?P=&n9PX&j z?nIl&E8XQ@xjq_OaXH=65;z@6;X}j7<69z)=okwe8|JE# ztF<1ky~Nur**%-MzJW*l_u)ghpfktaAM_i`&jHB9gKzt~pc^3I!nB@sJ>Ev77XjM4lYo66-58&8%?i#m6JZ z884^(T$1t%&qv#v_8@Rm$3qcQt<@D%bB?zCLeE$4Mg0=W$#$e#`?Y4l;GQ(^TaGse)rud65+G2-lmN-=<1nZ+FUYVp35-i`on}22@G7T>xV_nvM$&| zny&PAs`pC9nm&Ygk4}%c8TjRU`q6z6irhf@DL>G!%6yn-Z)~SSh zN?QKx%Hr0y*Zb$|K=JKK2%^HU8@gL^w0L^?z+_z5|87G_Xx_lz^M zMJ8;(j4bqQ3MKW>q(o07$D97f?O}YjM4)Pjboo;)+g z=Y1!iWeb*B%7z%B^aS5UCcDJdo4+k#_~q>A`fW@#1Wh$ov+Jrpjt3_wD*Ns;6BM-h zq!C#keUUST*GF-~>%ytRMIcB0ftg?gdcTjrp(7fpmwbe7w<2^5mOGJ=>vnf~lirSw zT9KRmONldgFRU^Wxr=PAcFQ8cP;(m{Qu%2+i-$ymb_Vbl3OBr+d;-Yd_!~ew&<0^5o$$p!==?cIp`h3 zD!4`wF2FdWx8kw)>`BV+w6?Oda0fSkNrPoBx?ju6hxnPfT%gz3njd(N`30y!mDBYU3U;DPSX#7o>?AOw+ zbMeHTdSIPXNPA6yQS|4p@`B3gqlVc0?!0fwYM|O*^KYO8){|lbYt#%*P*QRsC}q|iP{uf9T*HcPH;)# z(5Y98Z`35gRjf=;WyK}KXo1<37Yu4{S;t(=SN7l>(`z~e*cOJp9&fXd-FQ1}@dVsc z?Xdd7m#P2#!+)iznu?iyS^h(=jOt*pwjjZ$7jRxL`K4R_i--LPC;JIp`=vFJ*lX5T z8p-iO;CA5V@d4@XfBz_chgm)(ui=R`fscjdyva2Que;o1L^_f1MgPBk=r(YZo~i|> ze^KAMxuV$tJt+A*Zd5<9mbqd6uOCbS1m&Z$BlxO)&?0*XYT8#qpa0K1nB6KdPvB@G zXa=9WKiT18q5I-i^51Lm3sa9V!tQ)0P@vTH1_@_CV~x1R4etMJ5k0EtdJxZ?^bEKI zI1nQDG4~U-@9h4aTC(MsWrmlxf>l;NX^|li2!IKW46s$`qLqp`rlEkP5>ZcALj+ce z@GWW<(@L}?8l?r{r0|8<^klM`0%*gY=}ovdEbNS?&<|VYZ%>-g#$+`p3%_;S`_MJF}v+uw{7&W!Ej=t0q9n@*!hJJfnK%yT*_iyAmRJ z9rwv-ngRwoSxZwq9*GCNJ^WxW6V>{%M9q_MQ`z$k0cIgb`jDfZELv#?Et6hio}R1w z?PpKsqjyPt?anTq;+yg(a2PqM~G`DF)re)KfrdW$Vw4m>Y$|g;U5iq@&k8F`IjNrtkKB8RPvf)l+ z6Om&n8MmZ4HzPf)3RhQ|r`s+K>%dN(xuC8yl-Fzt2*Wclh5C?W;FZ*fc-)|KVTxU; zEN&c&=1O@>6D4yUu{R@wvz;hcpFwDxZc&Hf8b>G7?JP`>jufh*3L%p@xmE+=&62GG z*Xn1P1n_eZ5+Qqmm}_5ZLsFWuX9jigo5Ly+V-LFI`tY=ewmfxv3dI;R zec=X-;F;MNvU=P4Av-ps(jHH`S_l~-{A^emnA+NE@15H>jnr-W5OXv*KD9OU)2u`c zDPPL$j}V8bq!l5o1sW%i9ON$pl~Sz1S=ejXa(sEx~+{$7umDt|FJ zL-mdlEIR{EtO3(dAc|CSl=c{uS0D3XWkirlSP`g~&&V)WGb94K{W==n71M?0w%4+-r?_hI} z^1UW@({a6kQZV;N(=djnuh*%GVVKhq2<%2}0t5{-yBy}=ldK}>ivT3j$a2s5gHc$I z#2u?)`8u3d*H#SriM++KYzqvcR|OLF8qKTr0VdP7RrerF<99DWW5q<1QqB#u4W;zt zde{l_J9&UYqJL{`t4H3o8aY!uSVdl>Mwzuzp-c_TZ?fSId1 zTJD>gu25*m(WAHIh$s`gj|7O(1)*v1#kMJWE7LFRDkV^49?DxCPvJ zdCB?41wc>LH8XxznWHCru4UBPA%p>(&nu{$0=jCzSS?ZlIl}=y0_5Etuq72~^t0 z1Kp7r?>X3CFcIV!tPZc&_4r(wdExcCR2`+!G73rFo!)Pj`HLYNPo;t-(nXC1vd*UJ zCcn_BZTEabK{Aor@BvI+im_q|sYABI8*l-VCfxe>v!F}PVx&JQ(5ZhmOfsQaq*yH| zGWB8o!#f3kGuJ_hZ){kM1TR0nMeBc$@}^b+i9LNZhaOY&twHm5K!n;5c&Xz;YFmS= zQIvT~iO{6xoFSlL8D~=XtC;b%@mB+`9@7m?aoHyOST41was}pc8LBGJ9_rDjvT?py zy`pxDstnXNJ2s#8t{&Qa2p8P%cfH`;Tm-21cYQyzW-wZ_&LG^dP!XKg-A>t48T^qa zkMkuAgoZoY*$VEXH^e}LuoQS3nMxH2smbVr?!FO)tg7Lu{^bfaQ=biwkY27h>#1X0 z!|UOmS#$FN-F===s( zpGsfm`s%9=s1MOCip=ExQ)fcLb)+ZH3t8pKejbg#0; zpw=auzT8!dpD(2!0`k-usCU{ZD>Ok-iT&c^*eNzPSkfW@{+&IG*n4Jf&-3!jKvTfr zSfG~NmvEycDY%Hs0I|S8VG~D{a2M)^V4tv|yenc-Acd`I!d}08b(uN9j=Metn^rtj z{fUz`>H6MHvP4d{c6!7Lo5))W}u=b<`1Kb11f%zaYTI#CCO@y^fAgf|!o5tJ%# z_#*jk_1$CJD>8VC2(qAbn2XawT_aa|&ZQLrF3JFUV z!ae}Co|$WQZ$8`1rnQ1>`)aUY^|JLLU~f@fnEpd}ZXrJsgCV++ncW0(2?){ArN}4M zh&Oo%n`V)J7`tUCJbjx{?BzOwI^#s6ee(m;bgG^e4(~+yjdyhMy8AW48$*T1$L|29 zw)z}f=NK0mLRb8Dp#u$)w6r>#8bd@44V(-=#{dFbX>xc#p1YAjM|oFk*x(@;=vP5&4js(T>12lRyUa({ZOB&g03v zPP0gzNRo)fXOeGaO_-{8Z=VX|*i$YP()ksuM|AQ+=B@pb%wn(s#R1Y(3FpMys~Eaou7||<0EKp5II~a?%ZS92BqJhJ0{vwMbCLCz_uAEu z0H2lbfVSlT{WSE0W32N~IHGwpcdoXl#T@fJy)XOt6~;e5wp5JWxPOHiuPX9OX;oeg zPp@!OWDbiJ63d3}J4V24D#>L=(7|L8rF{jH-7d!uL{zlXLT%2)R@ULBK|m6KK37>} z=Z3Fs95@VZpl~z3B_l3XkrJd|Q{K(w7**&EBba}E!k+x~OK10meQC~m%WZ)!R)Vd- z9@P7E^$vKHDk-&owwI`Q-Dj65@U`%_9O*B@{q}NVk&|MZX(@zv_cme^IV$j;2eU6i zpHkze2GJEzkn%G}^hXjWi#Eivry*w{%7{dEt~#&CoQkoDbj$4dcpY(8J)a9ao823| z6jqu?3ZvB56L0lJ8H#E!Q$2`E5_{$YOZ=$!b( zooQ7%BzzJoyHagC!mDIW+XChpIYZqa;X)2KS8d6=z9njlrU-62vDF6jn&ay)5+CW> zuA(}I_kC@G{cxc_1qB@_Z-3PJGV8NMAcsPz0iUQ;(Y63} zo%yRV3GrN1FU#dlC4*3l6>=x=LNPXy7OS}ms)Ge``#9LS3|T%Yy|g?Z9+eM!<2zsj zp>pzTNAq33-h@p)jJ8+1S>@`L2F|Sr=R0Q1!%=cnRdZtm7K0X--QhQa^%y#wPu54% zAaQK#R0dfs^HZ1IAJK^VQ6P0W`z_zksK~S#EmAgxuW`^1OqU%rTuPIS8NB&lV1*A9 z9HJZFavxS8T!(NMpJeG6iYs}WT+52$6(A7_t@ZvM$jj`uxn-8^v=gt+r9-XxJD&c? zMTtT^rQ2hmyrM{Vx?2`^U_WI<9bwmeDaSH3XKzwDL9F7A(Ipx*_ur_WNnu5u|YJ0vqXVW0XA*I6Ut|woA(rCzL-Yj8G>LLVA8E zIgE(=*Yz_79RQJbb-)FVTEEJ%QYTDzaEl{~85M{^v z7LTHkiQETwusH5CPK#Cp7>9flmcoEI7$Puy&nbw_PzkVny+%gNDu_q5Ha3PwW_{V6 zZY3$|Z&*yB5=lH5j-k3N%sKszPZfDa!unM$`(^NFB!5SvSZRx6E5`*Ym+Z%gC2YV_ z2l2O9xNnSDOF*Jbp*i}VfUzYf+7j|-8RE7orTfq1jg!A9hJ1w@eoicE6#h=@)Pd7 zo070BP3%cSo?DJM>c5?TM(8XMnu=MBag2r*29vj3gBeox>G;r82|ILHAXotcI~zT-Fr>{rB|N3Y-8$De5zgO zR_xCn-;N5QqJ5Oc?`1V=W%snt~UWH;ZFUE1JcHPl;K+>*@PSl|B z5)8-1l`QoA=KK{9q$98&dFm9oszP}5xOjO^`58ai$82X(5V1`Q&gcVy>;2q|zLtt7 zeq@y`#?4EiP&Gv8ylhNZ8Z{xPdF_ytDleTc+?e$TxqypOMA46Q|4jE zf#fRk&P!+^pGh$E5|f}_i`$06`8_!drbN)iFH*7TCNg58MXWPW4MuS2W8ZQNPzmn@ zK5!nTbS!IiXQ+J$PnAy)RStlSXUy_(b)cqpa$uS}R5Dd8y+1-;u6j4MhjmCL!V%s;!OPRAovaeHM5V*!e<$98Zx zx@Zg#%!Bewa79?KnL9s?u56bUNDTT)yo?)F9VpkWiku>+nU7k-QHQ){-H8;%5$0UV zv1nij?}OZj2s=C(`;>GTB^5?>&T$fILL62EMs&a&Dw-mf7-jSG#YoJpCwIWf-9%Q| z*gT8e%^#gsi9uKiL{ZdXS5)Fi^A<)~Bo{u{3gH;@?x;qy?$1F%fh)x zyef!;)uu^(DNSues?Wxuf#p828gUHG5jn^`@U%y>&IQX+fLgbC~ZL)NN-3{;RE+nU%t8= zfO;xO;MW%a<_o+i0lPB6M*%}0KjrrG8-A0Q-I5pI0gm^o8`1ayPRJc_-krU4`E}vPa3&)0jetqZD1YmH(BqlpA%v6R4Z5j?YM}jM7}FFh3ZF7{}LU z?<}NnMb!#B6}BbAzp*NeRs%B*bdz@2nI>~4PraXyIj)2N+^!*Kxnd$)IMWXP=%20u zz-h+Umqr@t zG&d9sOZk|WM2Kkuz(z8UDo7NWO&{C5kt_S$esVtA=6#)nzbNpn?#r5Q;Q)6(4VX$4 zH~#~Re$bOq0e~d3A|W_yg(<9pU*^NcKp-11Kxq)|D2>5kZWjYUp-uk;@5Vz8;3zJ2 zt^|`6is%m?loQd{bVoCGzg`%Cbw7KIkh8)&gjg8U0#$a-(*H0qYeIWkUcwnel4Wsh z-XK4XPvZhSAKmJ=Wb<7wTHG3`i)r!vbhMTbWQEla%aGbY`5iDbi6H%ajpQ3Tk_aRt z1+v*gt&b|hYfIBrk~`GDxbi7?9vwfy5@_CYsi(>Mn$3O{O}tE>OrYqY_=DQSe@t3H&R)>DO2RDK9OxZeKT6`#dN*}4B0_k;gLqx*ruj{=&D!uU)HVGVs3Thp?(Ps>e`aB>J$yNpO*~{#$Ca(Tt_`IK8j; z;7*#0H0@;qwwSfq-`!X(S0}zW;c^jU88l@&vAes>=mjZaPdFZ+ zd`dgW#GC{SqsSCJ#`#TsHV8xz%jxlL_}g+FN3Pi%K4^IKC05CW1tB4Ad3a=+?!bi! zMoIduzH4N#SkHSeTbY#7S3*5+<0dflQ)|6U_OWJFQC#7mMP^#e16;-T5;H_Y>b-=8 z*K>RdP~m;;qPuwC8ocAc4MKUj$iL7ff%+|-nvrvNm9%d}iPs-GWY?D_K7fI?vd~CR zeSt=Q9}z=)-_Gy_s{flHWR9y&la-7Gy;T{pF@3(fEg#kg0YS^bx3~u(Y!(5gfP5z+ z((2f~+|V6UZ{0zw#QSY)aKGL~@{K~Fch^?`i-5#he*p1Fx$@071@^5kW99 zr@Y0?W`om+<>(lQ#oSaSTFOjhF9RtCN2?%@Bd?n~rFjX=^$eFBpJV{29;u{I`V=6@ zvmh@B(A>3nUm`=a{yOAEFj{xBfexdqHm#iKO@gAnU>$9 ze@*Tu+no3VwD&)uKaBY^BYsa25{;q-E_69V0$31>A^kx3q01k43+~B)rVB_^=7;V6 z#}CHYJe?Vmcd!urf4RsZB>z}4A^3ri(6Cq{qx2TMB9_uewzZ3o>L84An3d6qpA0X;@hzgL5@S|k- z8@HcmqJVf2a(H|#j{gM7P-BSz48pvBPvUQEF=VL|9RDmHf5rJ(PAvZV=Fcz^?C;wB zjoVKI*g(ix(*G&O&o@}Iuvk$4N%G^(5Bo#3`$xim$h+S$f0Fz)@BYdG3&IWQ2PUMP z{O3IoQel4{Kn*~Ilr_MgcSs{30{fE>;OG5kSmw9z4?h2<-QUCzCC5U9{WnZ3ByxZy5ssahgL{;R5@DXL(RyiE4^vJiv08}|Lxj=54@JyYMd3?zg z#a=NY6ReU{NtGZrz|&l|Fs!3%&G&>%=yDE+Tc`S39R6T=fKEUj)bzC&tuOZAwM4&7 zBqe>XjN34QUEMfsBxPQ~{?lGU6K#iQR1uT|k>n`_TX6dldXTL~OFm8A3Y-XB%Nk9v zL}A3Si`2pv+KSM0vr(%C%xl_k*612mXxD`@kQHT>cSDJZg8c(GrU*FLzF~R&SXkP#{g2iz|v7-5cid)0b=r`!@4+oXOftPutX+KP*CWcGy z9b-4g8#WBDDT2x6=8VpSbsc55xsorv;S8X_q@<3Yt1GUNy%gb7;_h0JF(FmwF?l|uRqF5MXLeI=Y9ffO) zCdkt7PKDbv`vcW4{ZJl+FNUX1SjBS+4njmC7og!ZziwxYInlsJOKP|yLp${>V~F`% zwiFEYJ_Hlz>AWvA%dC3#J z&ht%}#iTru7M(^857~pq!eDnR_l3g8jv@hBHrK$JN~u1n zCXt_G5RXL*G7R{TUeB~?M;c(^fsCy>kjFnn;cwt}3>CFOhh7NE00fg`WI~a`9L*s{ zgs&wG4Sc1V0FxrbpLZpM`%A#;I|~)E;6{?ndmVbAC2GYp*0)oNiUy((fTU<=*iaEd zurs@FaRWlUnu~LVAmeJIAvaS5=j>=H9Gv{O-YKGaC_!@r1qIsOT-t>agn*$?92eRs zOo@1D9HkKkWXKT>&s0QSL5pS1%%=5F5_!`((&K2(y`&P{AOM6%wAnMNz*FuVsKn>$ zP?lz3kf2dYaN)$zV6=+#C)Z)%wiWw0&=Jf8^78_w5W!xv5n940@1fwtau0KLRk{S( zf>kWJYT;E``;JXy=HDK{eGnY2QP?yE0DFq9-r4C>0cbKKRe6vesVkP`AM zpv08``p|7m9ww3Lh_>C`{2`R{HS!2LZHzPK05&Q;l|Fx?SBSmi^A$4!W58#THen;l z1=wY9Vw}>k>95L>YxwiKp`7?;5ECS+uxN1Zx3J%)qT#2)5JD%ON?($5Vc^RZJ15rW zKpU8<+Awe;;cTlPm5#9?520^Irdyh#BDw{M$4W8Gqy`d22<9TAs_ek|s?qzHFI>$C z0vHIN+X#fK)Yxo@lmf$}CETQmK7A<3xKt+lh>e*K3NL0#YMAeK55O{rOmyqbm9&R~ zE_*nmBSEOA3gSs_%T)r{ZLm8kn1_imU!9-mXps1? zq9M4@8Q5^JeTW6E6e5LA@Hw64#6JNWv(>rO-ZCPusK=Vv`(&zj7l|QD#lwn*FP!h{ zc7KtFlF@?Gu|J!bl0c@HV+X}8*39K+Vxx`#-s4B+ItMM3M*2$t{3WuDZu7+VPOLpc zKe$hiO9n&L%8Qwx(ZL=HA?GS$Vv3Z-+qi8Qn?TVi!m_(-*J%Y)*GBRKE%Y68{r5qL zDlr+N(uV#Ax#Y+%5vo;N$^FPN@lT7btKl<|?>-c&1i=S9{if0o`~?)S`jxkvX&3Dd zJ`aT5fQT%%&MmnmH+^~vr*RDv7UwFB0S>XmZ-~S2;RN960IE~9pu4kp-IAFL*tqZt z=C&m<)evK_>|nRg*$DTB z1U4dw9rd8jA30tDDVRbgm&suPaGKpPnoj7dtaf#@Bul}sr8fcO0EQ|6VY$ESeJbY; z*@^WXpGi3WdkHZ9TY>?91$7pVK%MA2UOD{6Rb>k1W2I|6V;VKqmU02m{9Vf$!0a>N8|s7MZOs^{?ghK8&e6MW}%)KeN_zcr}n5EL{F|3e4SmUZurH-^a?nzLtPUH8l>fjCOWzI1Z$>QzfhJ zrZhNKP&w_7w!z9RA&yqNhA&Bhra)x!*HvTc#YlxRMUHrnA#QHsMsHEVEAyDoOv=Y_ zI6XwfZI~WOW5(SYL=pqcFLltiQ{a-#{t;$hotV->w{^UTcLQJqpd-eE1oqh#Who?;WF%E`1%a9)9nAhB z0E#}u6w^wX^3u1e`!CTw0;$yzHOm1)T`sm^-8FgIWi&E)>apRkkmQnma=Q!Iz5c8_ zQBO5N=ubt0(16`@Ln>N+E1?*aY#Y9a27qW6{{px{_$l}?2SjZr&4lUgloMjAkW&N^ zdO@k^%MB=WKL=Afivd~M*H>xf)Fg`Rh_MAL6NDfb`0WfgBy?MAX_LHd`zi*Zg#Frh9`lUFCd4S!)z9cPW2vw z;@01*LW?khoM7q;`JJ$w;2LG_KP*8%EsnQ`?Jx^!fMqM>?&daO7NNoNXAMy}rYf~b zw$%&10^C05^7Rt6{)8t*Co1;$QbOAO2!<@&1U%i?i$N`IojV!yfrLC9r?-Zo+qjB@{JO-y zEE>QK@OImVjbK3DCBXGJi$*+ib?+um^^9pFCqhRdDKHl)PNod)_L6lEO#uzi3YoV} zL=%TY2Zk{5n}ZLIKK!lG>X$+gGYDbF*A2-vVhjrb9paiC2KIu*a<^0f*wESv)bgo8 z?0OxUHDrY_&|X^(S3fd>O?>(ps%5HmP4{g`6_muZI0=X_Ivw+!eN3kq>U#hcdKWwr zg#^AxjR*z*vuCmX7-fyxnueP5e)}-Ldf2}f|G@x$uKt7cuzxQ8b2bS$h4is&^Lik? zYe+vk_m9(YAU*5@$ZpL=*M95YPJ(GTxPrC9nK3+ex+JifZF&4oE~=Q!hRQ0~R6}8V z^)%O=rmyO9VSuEt13mEmBVD0vNXWiGXknqvV0uJy8ToE=IWJD=4gDyPSVL{DoQ+{s z(v#^Yy;Y(kOWMX{cU_a5A5MXGPBjJk@JL<}xZjp>#&}d|a@Jya**&O$VHwd7%YW!5GH6 zA}yo&jyoqiTm?^`Z&@UVWiPPasz3N$Y)L(QI;%d5MYX`Bro_&Zfer*IOk<5*zB8-K z#KsFoWc7P>du4g#FH!K7z{I)G#qR#7KDa*ZonH=i`MtoNCx|7+_z!;f#u-#P;{u@?{jp^1LSbeiQ6<=(j**Y{GTn#J1cn<3# zmSJ0n%N~~`=txOa>C{%7xeOhM7VW}AJ z1Kzc+mMV1g-u0>8BNlym_3|Mh(`auq` z00yte2s;^2A*L9j6fdqX=GYKJ6OQpe+U+ew%~}8!h#z%IgU!}G9aFBWke2%N$i&#b z?AM9&xknF`$12+|UH>s9>V|ZqC^xGr$;Ds3T^VSCWMo_rvcaTTq)#K7icV*xsen_k zaHJ@=)Qj&&@NQ@r*m;1gnB8Q$bX!h{gVRbFcE~Ft@NQKykp^7r)HA zp5BYO)?P%Bv8nNGDq{cOt@@zX0Z(gSzu1+p@m3M=Fsw-Wxv9r$NP&|JWod@9eS)Kf zOsx}lWR+3QSa|kgO3qSK;aPm0%}JYTv-)rZ3M;`ER;ik^cw6&TWfIrFii=m+GY@~L z1{?ij;CB%he_OQq-am2H4-TFzsuMUMApkB$J@Tceku*0CAhu7F&0$Jf(yA|kBcY|zpuw|ahXa_ULw#+L~B(N=+$3!BRq|M|WxQGfh_ z-S;Div6Xjq*VaeQim;PBD53?{jvmN}MZthJPJGw(m#Jiu1_@X)Ucn3;Vii3(xats2 zhS50-K+?3DG_o%l{aWx|`Ui`^^EQj@vJ(bZg}*4FBD$YPlr`V9l0_n2^)n}|^Z8&V zp%_L+vzB&E{<#biVTPDO|5$~=PSi2eZz{uNK)X>6ayTV{= z*5}VZBkPqOjeZq~)?r;gSvdNyo@VW?z`?iV_!a+oaPk`|)A&<|{PBrfr9)DFOW%#p zd^5(eNGGx{fXoAYO3y+Lpu+n2^H~+!;jsNlIPB}Y=e!)^vR-_;*D1&?#Pwt&#D1m_;MVaCan@eh z#+6J<8U#9?PMyH%Juu=R^nm_~ja)JYb7unXb!9WaZ!qR>Pe*29eLqsofOjf$L+ zLE!pI3>19G(3gBS|9XEZ82)*Rd3cI1|LkhUOYU}Pp(Qrd`>K(x z7BxM;bgHwmpi+=9`+DriVV;{ds=3LLw|PkEC>rQUDF`V>R{NL6*gw81NSj0B+=32e z@E89b+$y9SB?o;wD8=yQCeKMrj#R2uA3A1?bCO*FT|otW+xJ1`+92~1n2oEY8tC{m zH=R6H0Gpv((J_Ql*nKhxWve# z$%N0Tav*wv-lA9?fo|scgFB15^y5KQ3$}sHUV@Jck;d+(V6znL>G`XkYS$zOz-nM&|01$`LBmz+H0eHroC!@!C{5~7^ z)}xP!%2;vq;i?wLqbCo0L};sS;H7}o;l zE{L$bT=ltxz0|#T`pV&2+>o4U5XM)7*x_2(JfLoK1fZ4?Yx6M#+fe<<#jq?#PTNC+ zJ0%c`6t=TbWcNiCu)k~?kd~PE$`%aR7?m;oX8-xvdX@bf17zo|KzXaE5!-f9DO5cU zUzy##CJVs6=y0QXTlQa0w;>ae76VH&IfES@{>mL!{eqW<@W|({;!cnUaYJ30V>1p@ zk9Xej$opY;qj&Pr!3JL7g?r=_2V<3$Tg3^By03#wSGSWG$ z#o3eb!Ta0@;+vt5B(Blz*SyouqEWByV>yx4nud;aL)r2tYkf=$h3=|HW^nHAvmd9X z7qOK80NWfa(5m<+V+9BTv$F`_KRh-N4v^AN$6<&LelTnl<=M7xVRie?(jUkQ1h7b9 z<}TFH{*K&w>D?rNZ+|K~k8q~r-~w5mtHb%@2oGA_x4-PXvQYz(Dx++d0QfC{KE_v< zd4~%Q4$7Ls{uW4OS0fZC00x}N7R8BwY@js~WGNQxh-MI>W|^hI66%Sc>?is9_cqfd`VuDM+#0!e~yhKVT;5ZKxp7O5ytTEEJ& z0>~&P)=x`bJy78b$3D}w4dufysl$9sYV|e!{{Xg4A0an>x&}cnJ>(HNUjADL z*Tn>LHoWp^5!5k+rymBxAzoAXk4aVobB>nZoZ~r_o zD3zF%C%{XOo(MZg~SQ~ z*lql<0$2b$`KjV%g-=9KUGUtZJI796_K;)!6^CwEgz=Zcn;qi*mKB zRW@4dl65NjzCY%cJO2^iXXsByF?X(&7*6k1@uJ9-Me`fuSm+|LtXS*B-L=F>54Ah7 zhL^m9v!iSI^cF#a06j%$T@ z6cJSpQmtlvl-VLmm0@{>$1lj-ew1nL({#gIRQr-@=_9A0ip!gcItr2S!JF0W;@wAb zfWzV{*mZPZu@i%zJFipKZ3hM;O>S4i1~bp&Rfg`zEG88+acNM`rPPSKO!bZ*6**sf z^s~Gd3l$ElJGcOp=zR0G8(vDzxwhQw*SMyA15mk6)%XCp&$ndz4Fok8b$z=iQnrQ* zXb5cDM>ei*HFWe25{a%2N0MDJiW~m9xjWxF=vSOXYS$Xf4V}P>Kh;GO|f;Aaeb!yKh`y6LkUTz_r z1GUq_UPMy}oc$QCm{%yB%P7B7E=Ci9+J4Sp>wVFm5El z5sXmhw8iXCEViTEMXr)N)dfbchpNq!PO^$UcS6TkXy;*(LvMOTFA`Zfp!}=@?p`}p z#T0NZ$jQR!wwFZ9qD92df$$;3C!q%9_^tA}q-z zj^g#iFX{(zLKPRZvSyeTiLJ7yF#h=1vLRD2R7@RhNO_!^hP$F64F%57img6Hq9+6y zD-x3h6o29GfZ~u3gYujJa4I{sVV-L^&9ESUu6!vFhm@B8_+I0rwfJpwHIu8FY-q1p z8uaw{i`K+|;B~EZg-2K8YQ+u&QaH;r#M>I-vSu7*yz-ip{{h%dpK0kf2o#Xtr@c!9 zr34@85EM%5Pa%iD)}by}ZAg)5G29-0W^QCzNzl zXDH1`xvv;FGx~;e>vONomdJ^SNozY(AY3-(vag-(Hej;vRR*|5&kXBK3?#XT>~?wg zOJ}E_FI41>A2^V=I(08utm9Ls|J$hBko-J{EC4q4@`rru)IP2`fb8ng)~El!0Tp{( zfS%cGmUcQ5BZ)V~C}^nYpUVj3o5 zC1C1>qw8Hz{Q z#uOE2(`8}Py8f~ufQi?d)1a*)5qG{2N>Q^#`J0UL>9^C%&T19Qg8muQn}NBw!(~|u>`8o zKzLQ(p>r!O;nTQdMTJ7qOMR(X&-xfv_X)YsQH#ol=3AP9?CSR#MPRR}thvPnfU*Fz zXe4yV*<) z#Ok_oCxr?kPtz5awSTcQ9lhKFwY(Oe;IL9oshRCOpIiZPl>nlQFTy_cTHN-#g@{% zji4cY6`@#_8R+v)^>D?9&uI(=dta~vynguU)3?rR7;K7~-p}^BM&XcH8^lLAk5=9{ za-$dKl)ezhewmc1aNS^KYS)mPl(=*(Gx@F8uaCc8N(OjMYJLNxp<({LcHkSK9U|_y$Ou-pFZov_mLD@iq-T-9{_)@cSdl@;Bl_yagzn*AsJGj5+7==enbXgJLP;U-gSH8g*~o z2=#C5^Ms;h>39*@frs@DspB|#m!3<|Lsp9Y7UV@T#VBWCB~#ozuc5#K1#J1-$RfsB?q*HK@pEE-gjNeNQaa2<)QmLW0f_GYd{=DYiI}XAAtB{4a4Fd=8C@hj68&RrG%y zt?OTegpm<30xuVJSOCFj#tjLdu_pTag>VbRzA`aOV(qa1f}2)SL`YA7_a;`xUHcinT6v}wgAOmHsiqO$F9HKSk8TL z%aWpqPKi@j(1=7rOQhm!K3(zLwk!mRlUH4AT3PHD0e76@5N#=?5f+ca(7rNSf#WlR zl>5`Tn2x~cI(E$E4tX9^WX%g+45iJG5cLgD#yPQdt|5jb2QVqUf23FAYQPlQ_aabda*rr&l!T&EY6?q{C>johhvTy6aBQ=VQSF!AU+NAKRXm*fKjk#Gu-&z7-y?c_%(OfAHq8v6bhzCpiHRr@dvx@ICRxgKK}dQ(@9BV) zw5`@j`92(%&g7Vsc#kviKAR;2$Ej!`cDOwnAIQsvB~In$fKGIe5Q-b2>` zJm2qHW)pLw)_-@+R3mJ7&D}BKOnK^oF>T84n#Q$b%wM`j8K*~14=-{|Yu)CU3_hYI zzWbpv9lxc;-^U%*k2=18o@7c^Ki8`N$pVHYHS09J`*`KxHtYH)XGO-} zrS|l*iETJOP?o2IUEAFel-OqOcbBSl!gKSbI%{MNQb@ilEq>ZwliIRe#QwVBMWiAZ zB8KBR;5G;2u5$IPY(3w901{Lo!>Cx>j9;??K1k$|eYR#I5!1aNntK^0^nP%#55PJYaBAcAt-Tv>Uw@GFZ5ZrncZkOp$5U>f2y8)FfX)fJ zzVxEWfnS=Hi|hPo1xVKyTk;&Q>Q-2bXMK=jB(H->QGA`=p3&~xa=p1H6V*) zfFKaPpOo2Bp40eLdA#jm(s+n-w&N{Fpb8X%xl5Iwz0>BEiKQTfmCBw9#Z*`;q7p|p zv_ZAE{ju7_x`2VBTGD_A&HORVTl;mFzCTqI{>9GFA*;ym` zJHvM%l$?v}?`QGDXzR+mscQQwQ&~U~V+w$*sFExD&e+SvZ$gHf2Ik7COBZoMYDUw(BMEb{)= z(=XYT=Q6E&xE$3EB7F2zgck0JovOn)0EwuD%*4Wfl`!tzY)X*>)WJZ?;tweoKF9nGI9jG(`<@Q1K4p5(g{Thde*K<`o=AljKP1 z-wM09IV4)0QA!LhFvVqO!aRP#wzgiy7#p|s3c7}UTn|rOp7C}OFn&UxsIS=O3P&XNuyAfAEe6JVYnY%`fqCq`=V{bYHs#@p2pE{*>svc8Kxs{hQJCuLEy04O2s zfS2Y(zgB&wzLN{tx_e}!l z_z@MPu{Ys@s3vEhoy!j{UcG45Yq(>ReHz-EmkR^1ov0j7_|s^def;1XE9yh#3@|+| z?6MF=2^r!DP`XYXj!=&E5;J}*ei(NkoyfGkJioImxlcTK(nx8}*?>hqe)VyFbbd|G zSmA3vXGI^>alhTD;_Lr>te*X2=J*iFnF5Px`}?)woOyBfXUY|nYJXaK_9e3Y6 zb`NpdU2ecI1(n^}{fDd28RIted(Po!b6HP0g3Ga4PgKby$bvYC^`z`}dl2@@xn(&A)7f_ z=^^PI5yTz}9u^_*kn$Z{Fw>gp_jL1mVho?XCb82Sh!0B)Qv}{y`txm7wj}H)X;6&aZPGh+b;bS+GSrBhI*4_p{dfAc}?oDF~8Wn zbk*tMav7I`j(V6Q{r(I0OXr{9$$E)9FOmDl+WCwM9AuxZY=dY0gT>Tw0NOS6dD7U2 zIKSvUe|cJ{p!(c()8wWpyCtTEqB;Kj0IH;`;zzC$)W38nJ|@Ma*5pcn}lM`HUJJ9S5vXCwk(=4U&hZOHhh0KCcgXc G)&Bw1Mol~b diff --git a/src/SPIN/pair_spin_dipole_cut.cpp b/src/SPIN/pair_spin_dipole_cut.cpp index a393fe7021..a7372b480d 100644 --- a/src/SPIN/pair_spin_dipole_cut.cpp +++ b/src/SPIN/pair_spin_dipole_cut.cpp @@ -252,7 +252,7 @@ void PairSpinDipoleCut::compute(int eflag, int vflag) if (eflag) { if (rsq <= local_cut2) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; } } else evdwl = 0.0; diff --git a/src/SPIN/pair_spin_dmi.cpp b/src/SPIN/pair_spin_dmi.cpp index af68c0d256..04c2dc408d 100644 --- a/src/SPIN/pair_spin_dmi.cpp +++ b/src/SPIN/pair_spin_dmi.cpp @@ -319,7 +319,6 @@ void PairSpinDmi::compute_single_pair(int ii, double fmi[3]) // if interaction applies to type ii, // locflag = 1 and compute pair interaction - //i = ilist[ii]; if (locflag == 1) { xi[0] = x[ii][0]; @@ -373,9 +372,9 @@ void PairSpinDmi::compute_dmi(int i, int j, double eij[3], double fmi[3], double dmiy = eij[2]*v_dmx[itype][jtype] - eij[0]*v_dmz[itype][jtype]; dmiz = eij[0]*v_dmy[itype][jtype] - eij[1]*v_dmx[itype][jtype]; - fmi[0] -= 2.0*(dmiy*spj[2] - dmiz*spj[1]); - fmi[1] -= 2.0*(dmiz*spj[0] - dmix*spj[2]); - fmi[2] -= 2.0*(dmix*spj[1] - dmiy*spj[0]); + fmi[0] -= (dmiy*spj[2] - dmiz*spj[1]); + fmi[1] -= (dmiz*spj[0] - dmix*spj[2]); + fmi[2] -= (dmix*spj[1] - dmiy*spj[0]); } /* ---------------------------------------------------------------------- diff --git a/src/SPIN/pair_spin_exchange.cpp b/src/SPIN/pair_spin_exchange.cpp index 2aa8b99f32..6eacb04ee3 100644 --- a/src/SPIN/pair_spin_exchange.cpp +++ b/src/SPIN/pair_spin_exchange.cpp @@ -242,7 +242,8 @@ void PairSpinExchange::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; + // evdwl *= hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, diff --git a/src/SPIN/pair_spin_magelec.cpp b/src/SPIN/pair_spin_magelec.cpp index 664f8df56c..fabad4ae4d 100644 --- a/src/SPIN/pair_spin_magelec.cpp +++ b/src/SPIN/pair_spin_magelec.cpp @@ -251,7 +251,7 @@ void PairSpinMagelec::compute(int eflag, int vflag) if (eflag) { evdwl -= (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, @@ -362,17 +362,17 @@ void PairSpinMagelec::compute_magelec(int i, int j, double eij[3], double fmi[3] vy = v_mey[itype][jtype]; vz = v_mez[itype][jtype]; - meix = vy*eij[2] - vz*eij[1]; - meiy = vz*eij[0] - vx*eij[2]; - meiz = vx*eij[1] - vy*eij[0]; + meix = (vy*eij[2] - vz*eij[1]); + meiy = (vz*eij[0] - vx*eij[2]); + meiz = (vx*eij[1] - vy*eij[0]); meix *= ME[itype][jtype]; meiy *= ME[itype][jtype]; meiz *= ME[itype][jtype]; - fmi[0] += spj[1]*meiz - spj[2]*meiy; - fmi[1] += spj[2]*meix - spj[0]*meiz; - fmi[2] += spj[0]*meiy - spj[1]*meix; + fmi[0] += (spj[1]*meiz - spj[2]*meiy); + fmi[1] += (spj[2]*meix - spj[0]*meiz); + fmi[2] += (spj[0]*meiy - spj[1]*meix); } /* ---------------------------------------------------------------------- */ @@ -391,17 +391,17 @@ void PairSpinMagelec::compute_magelec_mech(int i, int j, double fi[3], double sp vy = v_mey[itype][jtype]; vz = v_mez[itype][jtype]; - meix = spi[1]*spi[2] - spi[2]*spj[1]; - meiy = spi[2]*spi[0] - spi[0]*spj[2]; - meiz = spi[0]*spi[1] - spi[1]*spj[0]; + meix = (spi[1]*spi[2] - spi[2]*spj[1]); + meiy = (spi[2]*spi[0] - spi[0]*spj[2]); + meiz = (spi[0]*spi[1] - spi[1]*spj[0]); meix *= ME_mech[itype][jtype]; meiy *= ME_mech[itype][jtype]; meiz *= ME_mech[itype][jtype]; - fi[0] += meiy*vz - meiz*vy; - fi[1] += meiz*vx - meix*vz; - fi[2] += meix*vy - meiy*vx; + fi[0] += (meiy*vz - meiz*vy); + fi[1] += (meiz*vx - meix*vz); + fi[2] += (meix*vy - meiy*vx); } diff --git a/src/SPIN/pair_spin_neel.cpp b/src/SPIN/pair_spin_neel.cpp index a3114497a6..4a5d453de2 100644 --- a/src/SPIN/pair_spin_neel.cpp +++ b/src/SPIN/pair_spin_neel.cpp @@ -260,7 +260,7 @@ void PairSpinNeel::compute(int eflag, int vflag) if (eflag) { evdwl = (spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]); - evdwl *= hbar; + evdwl *= 0.5*hbar; } else evdwl = 0.0; if (evflag) ev_tally_xyz(i,j,nlocal,newton_pair, From 8bca0b13f182e1c440df5838bf83185a2862201c Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 22 Nov 2019 16:29:37 -0700 Subject: [PATCH 499/557] Commit2 JT 112219 - correcting issue in src/SPIN/atom_vec_spin.cpp (inconsistency packing/unpacking hybrid) - rerunning all examples with corrections of former commit --- doc/src/pair_spin_exchange.rst | 4 +- doc/txt/pair_spin_exchange.txt | 5 +- examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 | 122 +++++----- examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 | 20 +- .../log.19Nov19.spin.cobalt_fcc.g++.1 | 64 ++--- .../log.19Nov19.spin.cobalt_fcc.g++.4 | 22 +- .../log.19Nov19.spin.cobalt_hcp.g++.1 | 220 +++++++++--------- .../log.19Nov19.spin.cobalt_hcp.g++.4 | 22 +- .../log.19Nov19.spin.iron_dipole_cut.g++.1 | 24 +- .../log.19Nov19.spin.iron_dipole_cut.g++.4 | 20 +- .../log.19Nov19.spin.iron_dipole_ewald.g++.1 | 28 +-- .../log.19Nov19.spin.iron_dipole_ewald.g++.4 | 22 +- .../log.19Nov19.spin.iron_dipole_pppm.g++.1 | 26 +-- .../log.19Nov19.spin.iron_dipole_pppm.g++.4 | 22 +- .../SPIN/iron/log.19Nov19.spin.iron.g++.1 | 64 ++--- .../SPIN/iron/log.19Nov19.spin.iron.g++.4 | 22 +- .../iron/log.19Nov19.spin.iron_cubic.g++.1 | 60 ++--- .../iron/log.19Nov19.spin.iron_cubic.g++.4 | 22 +- .../SPIN/nickel/log.19Nov19.spin.nickel.g++.1 | 64 ++--- .../SPIN/nickel/log.19Nov19.spin.nickel.g++.4 | 22 +- .../log.19Nov19.spin.nickel_cubic.g++.1 | 64 ++--- .../log.19Nov19.spin.nickel_cubic.g++.4 | 22 +- .../log.19Nov19.spin.read_data.g++.1 | 44 ++-- .../log.19Nov19.spin.read_data.g++.4 | 22 +- .../log.19Nov19.spin.restart.g++.1 | 42 ++-- .../log.19Nov19.spin.restart.g++.4 | 20 +- .../log.19Nov19.spin.write_restart.g++.1 | 40 ++-- .../log.19Nov19.spin.write_restart.g++.4 | 20 +- .../log.19Nov19.spin.setforce.g++.1 | 42 ++-- .../log.19Nov19.spin.setforce.g++.4 | 18 +- .../spinmin/log.19Nov19.spin.bfo_min.g++.1 | 62 ++--- .../spinmin/log.19Nov19.spin.bfo_min.g++.4 | 18 +- .../spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 | 42 ++-- .../spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 | 18 +- .../log.19Nov19.spin.bfo_min_lbfgs.g++.1 | 38 +-- .../log.19Nov19.spin.bfo_min_lbfgs.g++.4 | 16 +- .../spinmin/log.19Nov19.spin.iron_min.g++.1 | 38 +-- .../spinmin/log.19Nov19.spin.iron_min.g++.4 | 16 +- .../llg_exchange.py | 4 +- .../plot_precession.py | 2 +- ...bench-exchange.sh => run-test-exchange.sh} | 0 .../validation_damped_exchange/two_spins.data | 22 -- .../{run-bench-prec.sh => run-test-prec.sh} | 0 .../{run-bench-prec.sh => run-test-prec.sh} | 0 src/SPIN/atom_vec_spin.cpp | 9 +- src/SPIN/pair_spin_dipole_long.cpp | 2 +- 46 files changed, 737 insertions(+), 759 deletions(-) rename examples/SPIN/test_problems/validation_damped_exchange/{run-bench-exchange.sh => run-test-exchange.sh} (100%) delete mode 100644 examples/SPIN/test_problems/validation_damped_exchange/two_spins.data rename examples/SPIN/test_problems/validation_damped_precession/{run-bench-prec.sh => run-test-prec.sh} (100%) rename examples/SPIN/test_problems/validation_langevin_precession/{run-bench-prec.sh => run-test-prec.sh} (100%) diff --git a/doc/src/pair_spin_exchange.rst b/doc/src/pair_spin_exchange.rst index 5f7a630c60..add69f272c 100644 --- a/doc/src/pair_spin_exchange.rst +++ b/doc/src/pair_spin_exchange.rst @@ -35,7 +35,9 @@ pairs of magnetic spins: where si and sj are two neighboring magnetic spins of two particles, rij = \|ri - rj\| is the inter-atomic distance between the two particles, -and J(rij) is a function defining the intensity and the sign of the exchange +and + +J(rij) is a function defining the intensity and the sign of the exchange interaction for different neighboring shells. This function is defined as: .. image:: Eqs/pair_spin_exchange_function.jpg diff --git a/doc/txt/pair_spin_exchange.txt b/doc/txt/pair_spin_exchange.txt index 7bc6b5fef7..dea2d57f62 100644 --- a/doc/txt/pair_spin_exchange.txt +++ b/doc/txt/pair_spin_exchange.txt @@ -30,8 +30,9 @@ pairs of magnetic spins: :c,image(Eqs/pair_spin_exchange_interaction.jpg) where si and sj are two neighboring magnetic spins of two particles, -rij = |ri - rj| is the inter-atomic distance between the two particles, -and J(rij) is a function defining the intensity and the sign of the exchange +rij = |ri - rj| is the inter-atomic distance between the two +particles. The summation is over pairs of nearest neighbours. +J(rij) is a function defining the intensity and the sign of the exchange interaction for different neighboring shells. This function is defined as: :c,image(Eqs/pair_spin_exchange_function.jpg) diff --git a/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 index e7eb5cea59..b14210e9d0 100644 --- a/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 +++ b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.00234604 secs + create_atoms CPU = 0.00226784 secs # setting mass, mag. moments, and interactions for bfo @@ -82,71 +82,71 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 8.154 | 8.154 | 8.154 Mbytes Step Time v_magnorm PotEng KinEng v_emag Temp TotEng - 0 0 0.010071723 -0.11868622 0 -0.12966919 0 -0.11868622 - 10 0.002 0.010030399 -0.37068593 0 -0.38171598 0 -0.37068593 - 20 0.004 0.0099889925 -0.6223216 0 -0.6334048 0 -0.6223216 - 30 0.006 0.0099474775 -0.87359358 0 -0.88473539 0 -0.87359358 - 40 0.008 0.0099058307 -1.1245034 0 -1.1357086 0 -1.1245034 - 50 0.01 0.0098640297 -1.3750538 0 -1.3863265 0 -1.3750538 - 60 0.012 0.0098220536 -1.6252482 0 -1.6365919 0 -1.6252482 - 70 0.014 0.0097798824 -1.8750914 0 -1.8865086 0 -1.8750914 - 80 0.016 0.0097374974 -2.1245886 0 -2.1360814 0 -2.1245886 - 90 0.018 0.0096948809 -2.3737458 0 -2.3853154 0 -2.3737458 - 100 0.02 0.009652016 -2.6225698 0 -2.6342168 0 -2.6225698 - 110 0.022 0.0096088867 -2.8710677 0 -2.8827919 0 -2.8710677 - 120 0.024 0.0095654777 -3.1192468 0 -3.1310475 0 -3.1192468 - 130 0.026 0.0095217747 -3.367115 0 -3.3789906 0 -3.367115 - 140 0.028 0.0094777639 -3.61468 0 -3.6266285 0 -3.61468 - 150 0.03 0.0094334324 -3.8619496 0 -3.8739683 0 -3.8619496 - 160 0.032 0.0093887681 -4.1089316 0 -4.1210173 0 -4.1089316 - 170 0.034 0.0093437598 -4.3556334 0 -4.3677824 0 -4.3556334 - 180 0.036 0.0092983974 -4.6020625 0 -4.6142704 0 -4.6020625 - 190 0.038 0.0092526719 -4.8482255 0 -4.8604877 0 -4.8482255 - 200 0.04 0.0092065757 -5.0941291 0 -5.1064403 0 -5.0941291 - 210 0.042 0.0091601026 -5.3397792 0 -5.3521339 0 -5.3397792 - 220 0.044 0.0091132479 -5.5851813 0 -5.5975736 0 -5.5851813 - 230 0.046 0.009066009 -5.8303404 0 -5.842764 0 -5.8303404 - 240 0.048 0.0090183848 -6.0752609 0 -6.0877092 0 -6.0752609 - 250 0.05 0.0089703766 -6.3199467 0 -6.3324129 0 -6.3199467 - 260 0.052 0.0089219875 -6.5644011 0 -6.5768782 0 -6.5644011 - 270 0.054 0.008873223 -6.808627 0 -6.8211078 0 -6.808627 - 280 0.056 0.0088240907 -7.0526266 0 -7.0651038 0 -7.0526266 - 290 0.058 0.0087746007 -7.296402 0 -7.3088682 0 -7.296402 - 300 0.06 0.0087247649 -7.5399545 0 -7.5524024 0 -7.5399545 - 310 0.062 0.0086745977 -7.7832854 0 -7.7957077 0 -7.7832854 - 320 0.064 0.0086241151 -8.0263956 0 -8.038785 0 -8.0263956 - 330 0.066 0.0085733351 -8.2692858 0 -8.281635 0 -8.2692858 - 340 0.068 0.0085222773 -8.5119564 0 -8.5242586 0 -8.5119564 - 350 0.07 0.0084709628 -8.7544078 0 -8.7666562 0 -8.7544078 - 360 0.072 0.0084194137 -8.9966403 0 -9.0088285 0 -8.9966403 - 370 0.074 0.0083676531 -9.2386543 0 -9.2507761 0 -9.2386543 - 380 0.076 0.0083157047 -9.4804501 0 -9.4924997 0 -9.4804501 - 390 0.078 0.0082635926 -9.7220281 0 -9.7340001 0 -9.7220281 - 400 0.08 0.0082113413 -9.9633888 0 -9.9752784 0 -9.9633888 - 410 0.082 0.0081589748 -10.204533 0 -10.216336 0 -10.204533 - 420 0.084 0.0081065174 -10.445462 0 -10.457173 0 -10.445462 - 430 0.086 0.0080539926 -10.686176 0 -10.697793 0 -10.686176 - 440 0.088 0.0080014236 -10.926676 0 -10.938197 0 -10.926676 - 450 0.09 0.007948833 -11.166966 0 -11.178387 0 -11.166966 - 460 0.092 0.0078962428 -11.407045 0 -11.418366 0 -11.407045 - 470 0.094 0.0078436745 -11.646917 0 -11.658136 0 -11.646917 - 480 0.096 0.0077911488 -11.886583 0 -11.8977 0 -11.886583 - 490 0.098 0.0077386861 -12.126047 0 -12.137063 0 -12.126047 - 500 0.1 0.0076863063 -12.365311 0 -12.376226 0 -12.365311 -Loop time of 19.2298 on 1 procs for 500 steps with 5780 atoms + 0 0 0.010071723 -0.059343109 0 -0.13132609 0 -0.059343109 + 10 0.002 0.01003044 -0.18537022 0 -0.38338861 0 -0.18537022 + 20 0.004 0.0099890716 -0.31121926 0 -0.63509581 0 -0.31121926 + 30 0.006 0.0099475919 -0.43689013 0 -0.88644739 0 -0.43689013 + 40 0.008 0.0099059782 -0.5623833 0 -1.1374442 0 -0.5623833 + 50 0.01 0.0098642085 -0.68769978 0 -1.388088 0 -0.68769978 + 60 0.012 0.0098222618 -0.81284106 0 -1.6383818 0 -0.81284106 + 70 0.014 0.0097801186 -0.93780907 0 -1.8883294 0 -0.93780907 + 80 0.016 0.0097377603 -1.0626062 0 -2.1379352 0 -1.0626062 + 90 0.018 0.0096951693 -1.187235 0 -2.3872045 0 -1.187235 + 100 0.02 0.0096523288 -1.3116986 0 -2.6361432 0 -1.3116986 + 110 0.022 0.0096092227 -1.4360002 0 -2.8847577 0 -1.4360002 + 120 0.024 0.009565836 -1.5601431 0 -3.1330547 0 -1.5601431 + 130 0.026 0.0095221542 -1.6841309 0 -3.3810411 0 -1.6841309 + 140 0.028 0.0094781635 -1.8079673 0 -3.6287241 0 -1.8079673 + 150 0.03 0.0094338509 -1.9316557 0 -3.8761109 0 -1.9316557 + 160 0.032 0.0093892044 -2.0551997 0 -4.1232085 0 -2.0551997 + 170 0.034 0.0093442126 -2.178603 0 -4.370024 0 -2.178603 + 180 0.036 0.0092988654 -2.3018687 0 -4.6165639 0 -2.3018687 + 190 0.038 0.0092531537 -2.4250002 0 -4.8628348 0 -2.4250002 + 200 0.04 0.0092070698 -2.5480003 0 -5.1088426 0 -2.5480003 + 210 0.042 0.0091606073 -2.670872 0 -5.3545929 0 -2.670872 + 220 0.044 0.0091137617 -2.7936178 0 -5.6000909 0 -2.7936178 + 230 0.046 0.0090665298 -2.9162399 0 -5.8453412 0 -2.9162399 + 240 0.048 0.0090189108 -3.0387405 0 -6.0903478 0 -3.0387405 + 250 0.05 0.0089709056 -3.1611214 0 -6.3351146 0 -3.1611214 + 260 0.052 0.0089225173 -3.2833841 0 -6.5796445 0 -3.2833841 + 270 0.054 0.0088737511 -3.4055299 0 -6.8239403 0 -3.4055299 + 280 0.056 0.0088246147 -3.52756 0 -7.0680043 0 -3.52756 + 290 0.058 0.0087751176 -3.6494754 0 -7.3118383 0 -3.6494754 + 300 0.06 0.008725272 -3.7712768 0 -7.5554438 0 -3.7712768 + 310 0.062 0.0086750916 -3.8929648 0 -7.7988222 0 -3.8929648 + 320 0.064 0.0086245927 -4.0145399 0 -8.0419744 0 -4.0145399 + 330 0.066 0.0085737928 -4.1360026 0 -8.2849013 0 -4.1360026 + 340 0.068 0.0085227116 -4.2573532 0 -8.5276035 0 -4.2573532 + 350 0.07 0.0084713698 -4.378592 0 -8.7700818 0 -4.378592 + 360 0.072 0.0084197895 -4.4997194 0 -9.0123367 0 -4.4997194 + 370 0.074 0.0083679936 -4.6207358 0 -9.2543688 0 -4.6207358 + 380 0.076 0.0083160058 -4.7416414 0 -9.496179 0 -4.7416414 + 390 0.078 0.0082638503 -4.8624367 0 -9.7377681 0 -4.8624367 + 400 0.08 0.0082115512 -4.9831222 0 -9.9791371 0 -4.9831222 + 410 0.082 0.0081591329 -5.1036986 0 -10.220287 0 -5.1036986 + 420 0.084 0.0081066195 -5.2241665 0 -10.46122 0 -5.2241665 + 430 0.086 0.0080540347 -5.3445267 0 -10.701936 0 -5.3445267 + 440 0.088 0.008001402 -5.4647802 0 -10.942439 0 -5.4647802 + 450 0.09 0.0079487439 -5.5849281 0 -11.18273 0 -5.5849281 + 460 0.092 0.0078960829 -5.7049716 0 -11.422811 0 -5.7049716 + 470 0.094 0.0078434404 -5.824912 0 -11.662686 0 -5.824912 + 480 0.096 0.0077908378 -5.9447508 0 -11.902357 0 -5.9447508 + 490 0.098 0.0077382955 -6.0644896 0 -12.141828 0 -6.0644896 + 500 0.1 0.0076858338 -6.1841301 0 -12.381101 0 -6.1841301 +Loop time of 13.543 on 1 procs for 500 steps with 5780 atoms -Performance: 0.449 ns/day, 53.416 hours/ns, 26.001 timesteps/s -99.8% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.638 ns/day, 37.619 hours/ns, 36.919 timesteps/s +100.0% CPU use with 1 MPI tasks x no OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 5.2712 | 5.2712 | 5.2712 | 0.0 | 27.41 +Pair | 3.8138 | 3.8138 | 3.8138 | 0.0 | 28.16 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.039467 | 0.039467 | 0.039467 | 0.0 | 0.21 -Output | 0.060013 | 0.060013 | 0.060013 | 0.0 | 0.31 -Modify | 13.82 | 13.82 | 13.82 | 0.0 | 71.87 -Other | | 0.03928 | | | 0.20 +Comm | 0.011875 | 0.011875 | 0.011875 | 0.0 | 0.09 +Output | 0.049726 | 0.049726 | 0.049726 | 0.0 | 0.37 +Modify | 9.655 | 9.655 | 9.655 | 0.0 | 71.29 +Other | | 0.01262 | | | 0.09 Nlocal: 5780 ave 5780 max 5780 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -164,4 +164,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:19 +Total wall time: 0:00:13 diff --git a/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 index 8e3990787a..8c701c93c1 100644 --- a/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 +++ b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 2 by 2 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.000843048 secs + create_atoms CPU = 0.00149798 secs # setting mass, mag. moments, and interactions for bfo @@ -133,20 +133,20 @@ Step Time v_magnorm PotEng KinEng v_emag Temp TotEng 480 0.096 0.0077911486 -11.886583 0 -11.8977 0 -11.886583 490 0.098 0.007738686 -12.126047 0 -12.137063 0 -12.126047 500 0.1 0.0076863062 -12.365311 0 -12.376226 0 -12.365311 -Loop time of 5.69323 on 4 procs for 500 steps with 5780 atoms +Loop time of 3.94852 on 4 procs for 500 steps with 5780 atoms -Performance: 1.518 ns/day, 15.815 hours/ns, 87.824 timesteps/s -99.5% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 2.188 ns/day, 10.968 hours/ns, 126.630 timesteps/s +99.9% 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.2634 | 1.2866 | 1.3017 | 1.3 | 22.60 +Pair | 0.97416 | 0.98668 | 1.0022 | 1.0 | 24.99 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.17396 | 0.18913 | 0.21531 | 3.6 | 3.32 -Output | 0.020815 | 0.021116 | 0.021569 | 0.2 | 0.37 -Modify | 4.1846 | 4.1875 | 4.1896 | 0.1 | 73.55 -Other | | 0.008815 | | | 0.15 +Comm | 0.032618 | 0.04948 | 0.062614 | 5.0 | 1.25 +Output | 0.014166 | 0.014229 | 0.014374 | 0.1 | 0.36 +Modify | 2.8947 | 2.8957 | 2.8965 | 0.0 | 73.34 +Other | | 0.002385 | | | 0.06 Nlocal: 1445 ave 1445 max 1445 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -164,4 +164,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:05 +Total wall time: 0:00:03 diff --git a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 index fb95d9ab48..06774d0858 100644 --- a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 +++ b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.00110412 secs + create_atoms CPU = 0.000470161 secs # setting mass, mag. moments, and interactions for fcc cobalt @@ -87,41 +87,41 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 5.718 | 5.718 | 5.718 Mbytes Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng - 0 0 -0.099570972 0 0 1 -188.09051 100.00543 -2372.6129 - 50 0.005 -0.099570972 0 0 1 -188.09048 95.094679 -2372.6129 - 100 0.01 -0.099570972 0 0 1 -188.09007 81.578321 -2372.6129 - 150 0.015 -0.099570972 0 0 1 -188.08848 62.802727 -2372.6129 - 200 0.02 -0.099570972 0 0 1 -188.08487 43.35108 -2372.6129 - 250 0.025 -0.099570972 0 0 1 -188.07877 27.749821 -2372.6129 - 300 0.03 -0.099570972 0 0 1 -188.07054 19.149389 -2372.6129 - 350 0.035 -0.099570972 0 0 1 -188.06135 18.453387 -2372.6129 - 400 0.04 -0.099570972 0 0 1 -188.053 24.249423 -2372.6129 - 450 0.045 -0.099570972 0 0 1 -188.04742 33.548008 -2372.6129 - 500 0.05 -0.099570972 0 0 1 -188.04604 42.973172 -2372.6129 - 550 0.055 -0.099570972 0 0 1 -188.04935 49.902539 -2372.6129 - 600 0.06 -0.099570972 0 0 1 -188.0567 53.166772 -2372.6129 - 650 0.065 -0.099570972 0 0 1 -188.06642 53.153416 -2372.6129 - 700 0.07 -0.099570972 0 0 1 -188.07628 51.377187 -2372.6129 - 750 0.075 -0.099570972 0 0 1 -188.08415 49.725449 -2372.6129 - 800 0.08 -0.099570972 0 0 1 -188.08857 49.663576 -2372.6129 - 850 0.085 -0.099570972 0 0 1 -188.0891 51.681567 -2372.6129 - 900 0.09 -0.099570972 0 0 1 -188.08636 55.166554 -2372.6129 - 950 0.095 -0.099570972 0 0 1 -188.08174 58.718232 -2372.6129 - 1000 0.1 -0.099570972 0 0 1 -188.0769 60.75567 -2372.6129 -Loop time of 5.66302 on 1 procs for 1000 steps with 500 atoms + 0 0 -0.099570972 0 0 1 -188.09051 100.00543 -2278.6175 + 50 0.005 -0.099570972 0 0 1 -188.09048 95.094679 -2278.6175 + 100 0.01 -0.099570972 0 0 1 -188.09007 81.578321 -2278.6177 + 150 0.015 -0.099570972 0 0 1 -188.08848 62.802727 -2278.6185 + 200 0.02 -0.099570972 0 0 1 -188.08487 43.35108 -2278.6203 + 250 0.025 -0.099570972 0 0 1 -188.07877 27.749821 -2278.6233 + 300 0.03 -0.099570972 0 0 1 -188.07054 19.149389 -2278.6274 + 350 0.035 -0.099570972 0 0 1 -188.06135 18.453387 -2278.632 + 400 0.04 -0.099570972 0 0 1 -188.053 24.249423 -2278.6362 + 450 0.045 -0.099570972 0 0 1 -188.04742 33.548008 -2278.639 + 500 0.05 -0.099570972 0 0 1 -188.04604 42.973172 -2278.6397 + 550 0.055 -0.099570972 0 0 1 -188.04935 49.902539 -2278.638 + 600 0.06 -0.099570972 0 0 1 -188.0567 53.166772 -2278.6344 + 650 0.065 -0.099570972 0 0 1 -188.06642 53.153416 -2278.6295 + 700 0.07 -0.099570972 0 0 1 -188.07628 51.377187 -2278.6246 + 750 0.075 -0.099570972 0 0 1 -188.08415 49.725449 -2278.6206 + 800 0.08 -0.099570972 0 0 1 -188.08857 49.663576 -2278.6184 + 850 0.085 -0.099570972 0 0 1 -188.0891 51.681567 -2278.6182 + 900 0.09 -0.099570972 0 0 1 -188.08636 55.166554 -2278.6195 + 950 0.095 -0.099570972 0 0 1 -188.08174 58.718232 -2278.6218 + 1000 0.1 -0.099570972 0 0 1 -188.0769 60.75567 -2278.6243 +Loop time of 4.6196 on 1 procs for 1000 steps with 500 atoms -Performance: 1.526 ns/day, 15.731 hours/ns, 176.584 timesteps/s -100.0% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1.870 ns/day, 12.832 hours/ns, 216.469 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 | 2.8546 | 2.8546 | 2.8546 | 0.0 | 50.41 -Neigh | 0.012496 | 0.012496 | 0.012496 | 0.0 | 0.22 -Comm | 0.041981 | 0.041981 | 0.041981 | 0.0 | 0.74 -Output | 0.0014014 | 0.0014014 | 0.0014014 | 0.0 | 0.02 -Modify | 2.7441 | 2.7441 | 2.7441 | 0.0 | 48.46 -Other | | 0.008486 | | | 0.15 +Pair | 2.3116 | 2.3116 | 2.3116 | 0.0 | 50.04 +Neigh | 0.011227 | 0.011227 | 0.011227 | 0.0 | 0.24 +Comm | 0.032837 | 0.032837 | 0.032837 | 0.0 | 0.71 +Output | 0.00039411 | 0.00039411 | 0.00039411 | 0.0 | 0.01 +Modify | 2.2584 | 2.2584 | 2.2584 | 0.0 | 48.89 +Other | | 0.005152 | | | 0.11 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -139,4 +139,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:05 +Total wall time: 0:00:04 diff --git a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 index 6d8e74f37f..331ed60315 100644 --- a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 +++ b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.00073719 secs + create_atoms CPU = 0.000808001 secs # setting mass, mag. moments, and interactions for fcc cobalt @@ -108,20 +108,20 @@ Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng 900 0.09 -0.099570972 0 0 1 -188.08348 55.551378 -2372.6129 950 0.095 -0.099570972 0 0 1 -188.07838 57.540047 -2372.6129 1000 0.1 -0.099570972 0 0 1 -188.07314 58.088674 -2372.6129 -Loop time of 3.36398 on 4 procs for 1000 steps with 500 atoms +Loop time of 2.54753 on 4 procs for 1000 steps with 500 atoms -Performance: 2.568 ns/day, 9.344 hours/ns, 297.267 timesteps/s -99.1% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 3.392 ns/day, 7.076 hours/ns, 392.538 timesteps/s +100.0% 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.67186 | 0.78327 | 0.87877 | 8.5 | 23.28 -Neigh | 0.0027554 | 0.0033352 | 0.0038562 | 0.7 | 0.10 -Comm | 0.20661 | 0.30174 | 0.41594 | 14.1 | 8.97 -Output | 0.0007627 | 0.00084305 | 0.0010374 | 0.0 | 0.03 -Modify | 2.2674 | 2.2712 | 2.2779 | 0.3 | 67.52 -Other | | 0.003571 | | | 0.11 +Pair | 0.62017 | 0.6485 | 0.66275 | 2.1 | 25.46 +Neigh | 0.0027115 | 0.0029724 | 0.0030868 | 0.3 | 0.12 +Comm | 0.095047 | 0.1102 | 0.13819 | 5.0 | 4.33 +Output | 0.00039029 | 0.00042999 | 0.00049996 | 0.0 | 0.02 +Modify | 1.7801 | 1.7834 | 1.7852 | 0.1 | 70.01 +Other | | 0.002028 | | | 0.08 Nlocal: 125 ave 133 max 116 min Histogram: 1 0 0 0 0 2 0 0 0 1 @@ -139,4 +139,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:03 +Total wall time: 0:00:02 diff --git a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 index c534241f34..781e2264a7 100644 --- a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 +++ b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000491858 secs + create_atoms CPU = 0.00105 secs # setting mass, mag. moments, and interactions for hcp cobalt @@ -84,121 +84,121 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 7.902 | 7.902 | 7.902 Mbytes Step Time v_magnorm v_emag Temp Press TotEng - 0 0 0.076558814 -5.1073764 100.00543 -552.75983 -2190.3478 - 10 0.001 0.074494403 -6.2746901 100.01038 -1571.7966 -2191.5266 - 20 0.002 0.072366265 -7.4280779 99.885587 -2535.9845 -2192.6673 - 30 0.003 0.070127018 -8.5667999 99.611653 -3445.9872 -2193.7707 - 40 0.004 0.067755946 -9.6899272 99.164813 -4302.5715 -2194.8376 - 50 0.005 0.065261592 -10.79648 98.520535 -5107.2841 -2195.8697 - 60 0.006 0.062676613 -11.885341 97.657148 -5862.7198 -2196.8696 - 70 0.007 0.060046709 -12.955115 96.558718 -6572.0571 -2197.8404 - 80 0.008 0.057417313 -14.004096 95.216748 -7238.1396 -2198.7846 - 90 0.009 0.054822275 -15.030416 93.630634 -7862.5226 -2199.7028 - 100 0.01 0.052277835 -16.032345 91.80711 -8445.2646 -2200.5936 - 110 0.011 0.049783153 -17.008652 89.759163 -8985.5937 -2201.4546 - 120 0.012 0.047326373 -17.958895 87.504922 -9483.1141 -2202.2836 - 130 0.013 0.044893289 -18.883574 85.066818 -9938.8838 -2203.08 - 140 0.014 0.042474822 -19.784052 82.471014 -10355.911 -2203.8457 - 150 0.015 0.040070404 -20.662271 79.746901 -10739.081 -2204.5843 - 160 0.016 0.037686856 -21.520294 76.926428 -11094.793 -2205.3015 - 170 0.017 0.035334961 -22.359822 74.043181 -11430.247 -2206.0035 - 180 0.018 0.033026799 -23.181822 71.131269 -11752.268 -2206.6955 - 190 0.019 0.030775544 -23.986406 68.224204 -12065.774 -2207.3807 - 200 0.02 0.028597121 -24.773013 65.353995 -12372.712 -2208.0582 - 210 0.021 0.026511775 -25.540835 62.55053 -12672.055 -2208.7235 - 220 0.022 0.02454383 -26.289327 59.841288 -12961.112 -2209.3704 - 230 0.023 0.02271918 -27.018625 57.251361 -13237.544 -2209.9931 - 240 0.024 0.021061271 -27.729714 54.80373 -13501.028 -2210.5885 - 250 0.025 0.019587072 -28.42449 52.519717 -13754.325 -2211.1572 - 260 0.026 0.018304494 -29.105398 50.419388 -14002.718 -2211.7031 - 270 0.027 0.017211977 -29.775134 48.521812 -14253.089 -2212.2321 - 280 0.028 0.016300002 -30.436204 46.845075 -14512.437 -2212.7508 - 290 0.029 0.015553519 -31.090499 45.405985 -14786.53 -2213.2644 - 300 0.03 0.014954102 -31.739026 44.219544 -15079.165 -2213.7764 - 310 0.031 0.014481189 -32.381585 43.298175 -15391.531 -2214.2875 - 320 0.032 0.014112494 -33.016984 42.650874 -15722.828 -2214.7966 - 330 0.033 0.013824206 -33.643289 42.282535 -16070.874 -2215.3011 - 340 0.034 0.013591568 -34.258323 42.19365 -16433.065 -2215.7983 - 350 0.035 0.013390035 -34.860184 42.380506 -16807.186 -2216.286 - 360 0.036 0.01319679 -35.447655 42.835832 -17191.816 -2216.763 - 370 0.037 0.012992271 -36.020512 43.549656 -17586.676 -2217.2292 - 380 0.038 0.012761486 -36.579332 44.510078 -17991.857 -2217.6857 - 390 0.039 0.012494918 -37.125414 45.703757 -18407.738 -2218.1336 - 400 0.04 0.0121888 -37.660321 47.115967 -18834.276 -2218.5743 - 410 0.041 0.011844474 -38.185489 48.730291 -19270.674 -2219.0083 - 420 0.042 0.011466715 -38.70192 50.528119 -19715.276 -2219.4355 - 430 0.043 0.011061388 -39.21005 52.488204 -20165.66 -2219.8551 - 440 0.044 0.010633241 -39.709778 54.586528 -20618.997 -2220.266 - 450 0.045 0.010184696 -40.200724 56.79654 -21072.538 -2220.6671 - 460 0.046 0.0097161044 -40.682449 59.089699 -21523.873 -2221.0575 - 470 0.047 0.0092271788 -41.154614 61.436133 -21970.922 -2221.4371 - 480 0.048 0.0087187266 -41.617256 63.805414 -22412.32 -2221.8064 - 490 0.049 0.0081937768 -42.070708 66.167399 -22847.061 -2222.1664 - 500 0.05 0.0076576327 -42.51563 68.493235 -23274.619 -2222.5187 - 510 0.051 0.0071170477 -42.952841 70.756444 -23694.559 -2222.8652 - 520 0.052 0.006579078 -43.383338 72.933996 -24106.717 -2223.2075 - 530 0.053 0.006050144 -43.807962 75.007131 -24510.338 -2223.5467 - 540 0.054 0.0055354475 -44.227552 76.961803 -24904.495 -2223.8833 - 550 0.055 0.0050386503 -44.64268 78.788647 -25287.341 -2224.2166 - 560 0.056 0.0045617699 -45.053996 80.4825 -25657.11 -2224.5456 - 570 0.057 0.0041054334 -45.461923 82.041527 -26011.443 -2224.8688 - 580 0.058 0.003669689 -45.866895 83.466142 -26348.265 -2225.1846 - 590 0.059 0.0032553824 -46.269219 84.757926 -26665.834 -2225.492 - 600 0.06 0.0028655752 -46.669125 85.918711 -26963.24 -2225.7906 - 610 0.061 0.0025060765 -47.066641 86.95 -27240.331 -2226.0806 - 620 0.062 0.0021839971 -47.461566 87.852838 -27497.728 -2226.3626 - 630 0.063 0.0019039581 -47.853462 88.628142 -27736.503 -2226.6376 - 640 0.064 0.0016633855 -48.241747 89.277364 -27957.91 -2226.9064 - 650 0.065 0.0014502904 -48.625803 89.803307 -28163.11 -2227.1692 - 660 0.066 0.0012463786 -49.005026 90.210807 -28352.881 -2227.4258 - 670 0.067 0.0010345087 -49.378935 90.507107 -28527.721 -2227.6754 - 680 0.068 0.00080788134 -49.747325 90.701795 -28688.395 -2227.9175 - 690 0.069 0.000586442 -50.110227 90.80636 -28836.094 -2228.1522 - 700 0.07 0.00046855102 -50.467799 90.833539 -28972.361 -2228.3797 - 710 0.071 0.00061091693 -50.82044 90.796649 -29099.44 -2228.6011 - 720 0.072 0.00094960177 -51.168606 90.709122 -29219.676 -2228.8175 - 730 0.073 0.0013742455 -51.512913 90.584346 -29335.643 -2229.0301 - 740 0.074 0.0018397629 -51.853957 90.435783 -29449.521 -2229.2396 - 750 0.075 0.0023216474 -52.192407 90.277231 -29563.316 -2229.4468 - 760 0.076 0.0028000512 -52.528883 90.123061 -29678.726 -2229.6522 - 770 0.077 0.0032569295 -52.863859 89.98824 -29797.079 -2229.8564 - 780 0.078 0.0036765431 -53.197843 89.888047 -29919.964 -2230.06 - 790 0.079 0.0040467094 -53.530921 89.837568 -30048.271 -2230.2638 - 800 0.08 0.0043597837 -53.862938 89.850978 -30182.622 -2230.4682 - 810 0.081 0.0046129296 -54.193489 89.940884 -30323.293 -2230.6737 - 820 0.082 0.0048076151 -54.522077 90.117797 -30470.468 -2230.8804 - 830 0.083 0.004948533 -54.84813 90.389814 -30624.056 -2231.0884 - 840 0.084 0.0050423324 -55.171024 90.762454 -30783.658 -2231.2974 - 850 0.085 0.0050965581 -55.490357 91.238681 -30949.141 -2231.5072 - 860 0.086 0.0051190641 -55.805904 91.818973 -31120.5 -2231.7177 - 870 0.087 0.0051180301 -56.117429 92.501449 -31297.412 -2231.9286 - 880 0.088 0.0051024116 -56.424751 93.281992 -31479.436 -2232.1393 - 890 0.089 0.005082454 -56.727832 94.154367 -31666.293 -2232.3495 - 900 0.09 0.0050697645 -57.026442 95.110386 -31857.043 -2232.5582 - 910 0.091 0.0050765431 -57.320291 96.140056 -32050.436 -2232.7645 - 920 0.092 0.0051139309 -57.609075 97.231838 -32245.079 -2232.9672 - 930 0.093 0.0051899535 -57.89236 98.372982 -32439.141 -2233.1648 - 940 0.094 0.0053078572 -58.169742 99.54995 -32630.727 -2233.3559 - 950 0.095 0.0054654923 -58.44083 100.74893 -32817.882 -2233.5392 - 960 0.096 0.0056558757 -58.705483 101.95638 -32999.116 -2233.7136 - 970 0.097 0.0058685513 -58.963698 103.15953 -33173.159 -2233.8785 - 980 0.098 0.0060912487 -59.215624 104.34681 -33338.961 -2234.0336 - 990 0.099 0.0063114886 -59.461806 105.50819 -33496.345 -2234.1794 - 1000 0.1 0.0065179843 -59.702883 106.63524 -33645.259 -2234.3168 -Loop time of 5.86376 on 1 procs for 1000 steps with 500 atoms + 0 0 0.076558814 -5.1073764 100.00543 -552.75983 -2189.4486 + 10 0.001 0.074494403 -6.2746901 100.01038 -1571.7966 -2190.0317 + 20 0.002 0.072366265 -7.4280779 99.885587 -2535.9845 -2190.5874 + 30 0.003 0.070127018 -8.5667999 99.611653 -3445.9872 -2191.1169 + 40 0.004 0.067755946 -9.6899272 99.164813 -4302.5715 -2191.6215 + 50 0.005 0.065261592 -10.79648 98.520535 -5107.2841 -2192.103 + 60 0.006 0.062676613 -11.885341 97.657148 -5862.7198 -2192.5638 + 70 0.007 0.060046709 -12.955115 96.558718 -6572.0571 -2193.0064 + 80 0.008 0.057417313 -14.004096 95.216748 -7238.1396 -2193.4327 + 90 0.009 0.054822275 -15.030416 93.630634 -7862.5226 -2193.8437 + 100 0.01 0.052277835 -16.032345 91.80711 -8445.2646 -2194.2391 + 110 0.011 0.049783153 -17.008652 89.759163 -8985.5937 -2194.6181 + 120 0.012 0.047326373 -17.958895 87.504922 -9483.1141 -2194.98 + 130 0.013 0.044893289 -18.883574 85.066818 -9938.8838 -2195.3247 + 140 0.014 0.042474822 -19.784052 82.471014 -10355.911 -2195.6533 + 150 0.015 0.040070404 -20.662271 79.746901 -10739.081 -2195.9677 + 160 0.016 0.037686856 -21.520294 76.926428 -11094.793 -2196.2709 + 170 0.017 0.035334961 -22.359822 74.043181 -11430.247 -2196.5659 + 180 0.018 0.033026799 -23.181822 71.131269 -11752.268 -2196.8556 + 190 0.019 0.030775544 -23.986406 68.224204 -12065.774 -2197.1412 + 200 0.02 0.028597121 -24.773013 65.353995 -12372.712 -2197.4226 + 210 0.021 0.026511775 -25.540835 62.55053 -12672.055 -2197.6975 + 220 0.022 0.02454383 -26.289327 59.841288 -12961.112 -2197.9631 + 230 0.023 0.02271918 -27.018625 57.251361 -13237.544 -2198.2165 + 240 0.024 0.021061271 -27.729714 54.80373 -13501.028 -2198.4564 + 250 0.025 0.019587072 -28.42449 52.519717 -13754.325 -2198.6833 + 260 0.026 0.018304494 -29.105398 50.419388 -14002.718 -2198.8994 + 270 0.027 0.017211977 -29.775134 48.521812 -14253.089 -2199.1079 + 280 0.028 0.016300002 -30.436204 46.845075 -14512.437 -2199.3119 + 290 0.029 0.015553519 -31.090499 45.405985 -14786.53 -2199.5143 + 300 0.03 0.014954102 -31.739026 44.219544 -15079.165 -2199.7168 + 310 0.031 0.014481189 -32.381585 43.298175 -15391.531 -2199.9198 + 320 0.032 0.014112494 -33.016984 42.650874 -15722.828 -2200.1226 + 330 0.033 0.013824206 -33.643289 42.282535 -16070.874 -2200.324 + 340 0.034 0.013591568 -34.258323 42.19365 -16433.065 -2200.5226 + 350 0.035 0.013390035 -34.860184 42.380506 -16807.186 -2200.7174 + 360 0.036 0.01319679 -35.447655 42.835832 -17191.816 -2200.9077 + 370 0.037 0.012992271 -36.020512 43.549656 -17586.676 -2201.0935 + 380 0.038 0.012761486 -36.579332 44.510078 -17991.857 -2201.2754 + 390 0.039 0.012494918 -37.125414 45.703757 -18407.738 -2201.4538 + 400 0.04 0.0121888 -37.660321 47.115967 -18834.276 -2201.6292 + 410 0.041 0.011844474 -38.185489 48.730291 -19270.674 -2201.8019 + 420 0.042 0.011466715 -38.70192 50.528119 -19715.276 -2201.9716 + 430 0.043 0.011061388 -39.21005 52.488204 -20165.66 -2202.1377 + 440 0.044 0.010633241 -39.709778 54.586528 -20618.997 -2202.2998 + 450 0.045 0.010184696 -40.200724 56.79654 -21072.538 -2202.4571 + 460 0.046 0.0097161044 -40.682449 59.089699 -21523.873 -2202.6094 + 470 0.047 0.0092271788 -41.154614 61.436133 -21970.922 -2202.7565 + 480 0.048 0.0087187266 -41.617256 63.805414 -22412.32 -2202.8989 + 490 0.049 0.0081937768 -42.070708 66.167399 -22847.061 -2203.037 + 500 0.05 0.0076576327 -42.51563 68.493235 -23274.619 -2203.172 + 510 0.051 0.0071170477 -42.952841 70.756444 -23694.559 -2203.3046 + 520 0.052 0.006579078 -43.383338 72.933996 -24106.717 -2203.4358 + 530 0.053 0.006050144 -43.807962 75.007131 -24510.338 -2203.5662 + 540 0.054 0.0055354475 -44.227552 76.961803 -24904.495 -2203.6957 + 550 0.055 0.0050386503 -44.64268 78.788647 -25287.341 -2203.8241 + 560 0.056 0.0045617699 -45.053996 80.4825 -25657.11 -2203.9504 + 570 0.057 0.0041054334 -45.461923 82.041527 -26011.443 -2204.0737 + 580 0.058 0.003669689 -45.866895 83.466142 -26348.265 -2204.1931 + 590 0.059 0.0032553824 -46.269219 84.757926 -26665.834 -2204.3077 + 600 0.06 0.0028655752 -46.669125 85.918711 -26963.24 -2204.4173 + 610 0.061 0.0025060765 -47.066641 86.95 -27240.331 -2204.5218 + 620 0.062 0.0021839971 -47.461566 87.852838 -27497.728 -2204.6218 + 630 0.063 0.0019039581 -47.853462 88.628142 -27736.503 -2204.7177 + 640 0.064 0.0016633855 -48.241747 89.277364 -27957.91 -2204.81 + 650 0.065 0.0014502904 -48.625803 89.803307 -28163.11 -2204.899 + 660 0.066 0.0012463786 -49.005026 90.210807 -28352.881 -2204.9847 + 670 0.067 0.0010345087 -49.378935 90.507107 -28527.721 -2205.0668 + 680 0.068 0.00080788134 -49.747325 90.701795 -28688.395 -2205.1453 + 690 0.069 0.000586442 -50.110227 90.80636 -28836.094 -2205.22 + 700 0.07 0.00046855102 -50.467799 90.833539 -28972.361 -2205.2911 + 710 0.071 0.00061091693 -50.82044 90.796649 -29099.44 -2205.3592 + 720 0.072 0.00094960177 -51.168606 90.709122 -29219.676 -2205.4249 + 730 0.073 0.0013742455 -51.512913 90.584346 -29335.643 -2205.4887 + 740 0.074 0.0018397629 -51.853957 90.435783 -29449.521 -2205.5511 + 750 0.075 0.0023216474 -52.192407 90.277231 -29563.316 -2205.6124 + 760 0.076 0.0028000512 -52.528883 90.123061 -29678.726 -2205.6729 + 770 0.077 0.0032569295 -52.863859 89.98824 -29797.079 -2205.7329 + 780 0.078 0.0036765431 -53.197843 89.888047 -29919.964 -2205.7925 + 790 0.079 0.0040467094 -53.530921 89.837568 -30048.271 -2205.8521 + 800 0.08 0.0043597837 -53.862938 89.850978 -30182.622 -2205.9119 + 810 0.081 0.0046129296 -54.193489 89.940884 -30323.293 -2205.9718 + 820 0.082 0.0048076151 -54.522077 90.117797 -30470.468 -2206.0321 + 830 0.083 0.004948533 -54.84813 90.389814 -30624.056 -2206.0926 + 840 0.084 0.0050423324 -55.171024 90.762454 -30783.658 -2206.1532 + 850 0.085 0.0050965581 -55.490357 91.238681 -30949.141 -2206.2139 + 860 0.086 0.0051190641 -55.805904 91.818973 -31120.5 -2206.2745 + 870 0.087 0.0051180301 -56.117429 92.501449 -31297.412 -2206.3349 + 880 0.088 0.0051024116 -56.424751 93.281992 -31479.436 -2206.3949 + 890 0.089 0.005082454 -56.727832 94.154367 -31666.293 -2206.4544 + 900 0.09 0.0050697645 -57.026442 95.110386 -31857.043 -2206.513 + 910 0.091 0.0050765431 -57.320291 96.140056 -32050.436 -2206.5703 + 920 0.092 0.0051139309 -57.609075 97.231838 -32245.079 -2206.6257 + 930 0.093 0.0051899535 -57.89236 98.372982 -32439.141 -2206.6788 + 940 0.094 0.0053078572 -58.169742 99.54995 -32630.727 -2206.7288 + 950 0.095 0.0054654923 -58.44083 100.74893 -32817.882 -2206.7752 + 960 0.096 0.0056558757 -58.705483 101.95638 -32999.116 -2206.8176 + 970 0.097 0.0058685513 -58.963698 103.15953 -33173.159 -2206.8557 + 980 0.098 0.0060912487 -59.215624 104.34681 -33338.961 -2206.8893 + 990 0.099 0.0063114886 -59.461806 105.50819 -33496.345 -2206.9188 + 1000 0.1 0.0065179843 -59.702883 106.63524 -33645.259 -2206.9444 +Loop time of 5.20295 on 1 procs for 1000 steps with 500 atoms -Performance: 1.473 ns/day, 16.288 hours/ns, 170.539 timesteps/s +Performance: 1.661 ns/day, 14.453 hours/ns, 192.199 timesteps/s 100.0% 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.9866 | 2.9866 | 2.9866 | 0.0 | 50.93 -Neigh | 0.016013 | 0.016013 | 0.016013 | 0.0 | 0.27 -Comm | 0.046018 | 0.046018 | 0.046018 | 0.0 | 0.78 -Output | 0.011075 | 0.011075 | 0.011075 | 0.0 | 0.19 -Modify | 2.7957 | 2.7957 | 2.7957 | 0.0 | 47.68 -Other | | 0.008332 | | | 0.14 +Pair | 2.6241 | 2.6241 | 2.6241 | 0.0 | 50.43 +Neigh | 0.01424 | 0.01424 | 0.01424 | 0.0 | 0.27 +Comm | 0.041207 | 0.041207 | 0.041207 | 0.0 | 0.79 +Output | 0.0090086 | 0.0090086 | 0.0090086 | 0.0 | 0.17 +Modify | 2.5084 | 2.5084 | 2.5084 | 0.0 | 48.21 +Other | | 0.006008 | | | 0.12 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 index 21adab3f19..de00d5be32 100644 --- a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 +++ b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000671148 secs + create_atoms CPU = 0.00101995 secs # setting mass, mag. moments, and interactions for hcp cobalt @@ -185,20 +185,20 @@ Step Time v_magnorm v_emag Temp Press TotEng 980 0.098 0.010180127 -59.986126 110.79823 -33816.218 -2234.0455 990 0.099 0.010181304 -60.24929 112.17528 -34000.522 -2234.1984 1000 0.1 0.01012881 -60.508632 113.46137 -34179.052 -2234.3508 -Loop time of 4.82687 on 4 procs for 1000 steps with 500 atoms +Loop time of 2.93788 on 4 procs for 1000 steps with 500 atoms -Performance: 1.790 ns/day, 13.408 hours/ns, 207.173 timesteps/s -97.6% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 2.941 ns/day, 8.161 hours/ns, 340.381 timesteps/s +100.0% 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.1741 | 1.3056 | 1.4605 | 11.5 | 27.05 -Neigh | 0.0042465 | 0.0048378 | 0.0051758 | 0.5 | 0.10 -Comm | 0.31356 | 0.406 | 0.47906 | 11.6 | 8.41 -Output | 0.0090122 | 0.0094153 | 0.010493 | 0.6 | 0.20 -Modify | 3.0298 | 3.0936 | 3.1534 | 3.4 | 64.09 -Other | | 0.007349 | | | 0.15 +Pair | 0.72349 | 0.73783 | 0.7554 | 1.3 | 25.11 +Neigh | 0.00353 | 0.0036981 | 0.0038559 | 0.2 | 0.13 +Comm | 0.12285 | 0.14476 | 0.16041 | 3.6 | 4.93 +Output | 0.0046515 | 0.0047909 | 0.0050418 | 0.2 | 0.16 +Modify | 2.0407 | 2.0439 | 2.0482 | 0.2 | 69.57 +Other | | 0.00288 | | | 0.10 Nlocal: 125 ave 136 max 119 min Histogram: 1 1 1 0 0 0 0 0 0 1 @@ -216,4 +216,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:04 +Total wall time: 0:00:02 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 index 9c4b9e6877..c2af23d167 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.00068903 secs + create_atoms CPU = 0.000741005 secs # setting mass, mag. moments, and interactions for bcc iron @@ -88,23 +88,23 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 13.4 | 13.4 | 13.4 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng - 0 0 -1 0 0 1 1.0737264e-35 -768.37511 -15560.055 -15515.394 - 50 0.005 -1 -2.7722752e-10 -2.1828666e-10 1 6.8846921e-09 -768.35793 -15558.423 -15515.394 - 100 0.01 -1 -2.0983066e-09 -1.7330951e-09 1 1.0038885e-08 -768.30868 -15553.81 -15515.394 -Loop time of 9.81833 on 1 procs for 100 steps with 3456 atoms + 0 0 -1 0 0 1 1.0737264e-35 -768.37511 -15175.868 -15131.207 + 50 0.005 -1 -2.7722752e-10 -2.1828666e-10 1 6.8846921e-09 -768.35793 -15174.244 -15131.215 + 100 0.01 -1 -2.0983066e-09 -1.7330951e-09 1 1.0038885e-08 -768.30868 -15169.656 -15131.24 +Loop time of 7.86359 on 1 procs for 100 steps with 3456 atoms -Performance: 0.088 ns/day, 272.731 hours/ns, 10.185 timesteps/s +Performance: 0.110 ns/day, 218.433 hours/ns, 12.717 timesteps/s 100.0% CPU use with 1 MPI tasks x no OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 4.5684 | 4.5684 | 4.5684 | 0.0 | 46.53 +Pair | 3.6134 | 3.6134 | 3.6134 | 0.0 | 45.95 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.022333 | 0.022333 | 0.022333 | 0.0 | 0.23 -Output | 0.0062339 | 0.0062339 | 0.0062339 | 0.0 | 0.06 -Modify | 5.2097 | 5.2097 | 5.2097 | 0.0 | 53.06 -Other | | 0.01171 | | | 0.12 +Comm | 0.014062 | 0.014062 | 0.014062 | 0.0 | 0.18 +Output | 0.006057 | 0.006057 | 0.006057 | 0.0 | 0.08 +Modify | 4.226 | 4.226 | 4.226 | 0.0 | 53.74 +Other | | 0.004064 | | | 0.05 Nlocal: 3456 ave 3456 max 3456 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -122,4 +122,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:09 +Total wall time: 0:00:07 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 index 6bd13bff4b..1f8157bb29 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.00121498 secs + create_atoms CPU = 0.00090003 secs # setting mass, mag. moments, and interactions for bcc iron @@ -91,20 +91,20 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 0 0 -1 0 0 1 1.0737264e-35 -768.37511 -15560.055 -15515.394 50 0.005 -1 9.6204015e-11 -3.3767807e-10 1 6.6905249e-09 -768.35767 -15558.438 -15515.394 100 0.01 -1 7.8881609e-10 -2.7017321e-09 1 9.8111281e-09 -768.30769 -15553.868 -15515.394 -Loop time of 4.21054 on 4 procs for 100 steps with 3456 atoms +Loop time of 2.29116 on 4 procs for 100 steps with 3456 atoms -Performance: 0.205 ns/day, 116.959 hours/ns, 23.750 timesteps/s -97.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 0.377 ns/day, 63.643 hours/ns, 43.646 timesteps/s +99.9% 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.5515 | 1.5909 | 1.6287 | 2.8 | 37.78 +Pair | 0.92259 | 0.92963 | 0.93393 | 0.4 | 40.57 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.1219 | 0.15371 | 0.18852 | 8.1 | 3.65 -Output | 0.0032659 | 0.0032846 | 0.0033138 | 0.0 | 0.08 -Modify | 2.4491 | 2.4549 | 2.4589 | 0.3 | 58.30 -Other | | 0.007701 | | | 0.18 +Comm | 0.02284 | 0.027597 | 0.035185 | 2.8 | 1.20 +Output | 0.0018489 | 0.0018544 | 0.0018642 | 0.0 | 0.08 +Modify | 1.3296 | 1.3303 | 1.3308 | 0.0 | 58.06 +Other | | 0.001818 | | | 0.08 Nlocal: 864 ave 864 max 864 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -122,4 +122,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:04 +Total wall time: 0:00:02 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 index 9bd3b04a06..9a38445af5 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.000730038 secs + create_atoms CPU = 0.00166988 secs # setting mass, mag. moments, and interactions for bcc iron @@ -97,24 +97,24 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 30.07 | 30.07 | 30.07 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng - 0 0 -1 0 0 1 2.5872886e-37 -767.88567 -15559.577 -15514.916 - 50 0.005 -1 4.3660916e-09 -2.1918692e-09 1 5.3480999e-10 -767.86847 -15557.945 -15514.916 - 100 0.01 -1 9.9854966e-09 -4.2823677e-09 1 2.3267629e-09 -767.81917 -15553.332 -15514.916 -Loop time of 30.1001 on 1 procs for 100 steps with 3456 atoms + 0 0 -1 0 0 1 2.5872886e-37 -767.88567 -15175.39 -15130.729 + 50 0.005 -1 4.3660916e-09 -2.1918692e-09 1 5.3480999e-10 -767.86847 -15173.766 -15130.738 + 100 0.01 -1 9.9854966e-09 -4.2823677e-09 1 2.3267629e-09 -767.81917 -15169.178 -15130.762 +Loop time of 24.9345 on 1 procs for 100 steps with 3456 atoms -Performance: 0.029 ns/day, 836.115 hours/ns, 3.322 timesteps/s -99.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.035 ns/day, 692.624 hours/ns, 4.011 timesteps/s +100.0% CPU use with 1 MPI tasks x no OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 5.6659 | 5.6659 | 5.6659 | 0.0 | 18.82 -Kspace | 12.686 | 12.686 | 12.686 | 0.0 | 42.14 +Pair | 4.8022 | 4.8022 | 4.8022 | 0.0 | 19.26 +Kspace | 10.337 | 10.337 | 10.337 | 0.0 | 41.46 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.022781 | 0.022781 | 0.022781 | 0.0 | 0.08 -Output | 0.00965 | 0.00965 | 0.00965 | 0.0 | 0.03 -Modify | 11.705 | 11.705 | 11.705 | 0.0 | 38.89 -Other | | 0.01108 | | | 0.04 +Comm | 0.013856 | 0.013856 | 0.013856 | 0.0 | 0.06 +Output | 0.007138 | 0.007138 | 0.007138 | 0.0 | 0.03 +Modify | 9.7705 | 9.7705 | 9.7705 | 0.0 | 39.18 +Other | | 0.004077 | | | 0.02 Nlocal: 3456 ave 3456 max 3456 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -132,4 +132,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:30 +Total wall time: 0:00:25 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 index 4989210d1d..306799f576 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.00238299 secs + create_atoms CPU = 0.00088191 secs # setting mass, mag. moments, and interactions for bcc iron @@ -100,21 +100,21 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 0 0 -1 0 0 1 3.5107565e-37 -767.88567 -15559.577 -15514.916 50 0.005 -1 4.3196063e-09 -2.1966927e-09 1 5.1719577e-10 -767.86822 -15557.96 -15514.916 100 0.01 -1 9.7636593e-09 -4.3236953e-09 1 2.2443181e-09 -767.81819 -15553.39 -15514.916 -Loop time of 11.709 on 4 procs for 100 steps with 3456 atoms +Loop time of 6.80139 on 4 procs for 100 steps with 3456 atoms -Performance: 0.074 ns/day, 325.251 hours/ns, 8.540 timesteps/s -99.7% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 0.127 ns/day, 188.927 hours/ns, 14.703 timesteps/s +100.0% 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.7524 | 1.9105 | 2.0593 | 9.8 | 16.32 -Kspace | 4.1375 | 4.4309 | 4.7029 | 12.3 | 37.84 +Pair | 1.248 | 1.2649 | 1.2816 | 1.1 | 18.60 +Kspace | 2.523 | 2.5743 | 2.6505 | 3.0 | 37.85 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.063121 | 0.47268 | 0.94431 | 59.7 | 4.04 -Output | 0.0032601 | 0.0033116 | 0.0033839 | 0.1 | 0.03 -Modify | 4.8621 | 4.8828 | 4.9008 | 0.8 | 41.70 -Other | | 0.008918 | | | 0.08 +Comm | 0.029461 | 0.087268 | 0.13754 | 13.0 | 1.28 +Output | 0.0018618 | 0.001869 | 0.0018811 | 0.0 | 0.03 +Modify | 2.8692 | 2.8709 | 2.8741 | 0.1 | 42.21 +Other | | 0.002119 | | | 0.03 Nlocal: 864 ave 864 max 864 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -132,4 +132,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:11 +Total wall time: 0:00:06 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 index 5984976c8d..b0e87d786d 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.000930071 secs + create_atoms CPU = 0.00166583 secs # setting mass, mag. moments, and interactions for bcc iron @@ -99,24 +99,24 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 16.27 | 16.27 | 16.27 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng - 0 0 -1 0 0 1 3.7996771e-37 -767.89759 -15559.59 -15514.929 - 50 0.005 -1 3.6585337e-09 -1.9445403e-09 1 5.1405121e-10 -767.88039 -15557.958 -15514.929 - 100 0.01 -1 7.3585728e-09 -3.8640878e-09 1 2.0194927e-09 -767.83109 -15553.345 -15514.929 -Loop time of 18.493 on 1 procs for 100 steps with 3456 atoms + 0 0 -1 0 0 1 3.7996771e-37 -767.89759 -15175.402 -15130.741 + 50 0.005 -1 3.6585337e-09 -1.9445403e-09 1 5.1405121e-10 -767.88039 -15173.779 -15130.75 + 100 0.01 -1 7.3585728e-09 -3.8640878e-09 1 2.0194927e-09 -767.83109 -15169.191 -15130.774 +Loop time of 15.3615 on 1 procs for 100 steps with 3456 atoms -Performance: 0.047 ns/day, 513.694 hours/ns, 5.407 timesteps/s +Performance: 0.056 ns/day, 426.709 hours/ns, 6.510 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 | 5.7715 | 5.7715 | 5.7715 | 0.0 | 31.21 -Kspace | 0.82553 | 0.82553 | 0.82553 | 0.0 | 4.46 +Pair | 4.8418 | 4.8418 | 4.8418 | 0.0 | 31.52 +Kspace | 0.66626 | 0.66626 | 0.66626 | 0.0 | 4.34 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.022319 | 0.022319 | 0.022319 | 0.0 | 0.12 -Output | 0.0066397 | 0.0066397 | 0.0066397 | 0.0 | 0.04 -Modify | 11.857 | 11.857 | 11.857 | 0.0 | 64.12 -Other | | 0.009629 | | | 0.05 +Comm | 0.014248 | 0.014248 | 0.014248 | 0.0 | 0.09 +Output | 0.0064788 | 0.0064788 | 0.0064788 | 0.0 | 0.04 +Modify | 9.8279 | 9.8279 | 9.8279 | 0.0 | 63.98 +Other | | 0.00478 | | | 0.03 Nlocal: 3456 ave 3456 max 3456 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -134,4 +134,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:19 +Total wall time: 0:00:16 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 index 154e39958d..4fbd0eb52b 100644 --- a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 3456 atoms - create_atoms CPU = 0.00089097 secs + create_atoms CPU = 0.00123286 secs # setting mass, mag. moments, and interactions for bcc iron @@ -102,21 +102,21 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 0 0 -1 0 0 1 2.3173191e-37 -767.89759 -15559.59 -15514.929 50 0.005 -1 3.6593054e-09 -1.9379563e-09 1 4.9747018e-10 -767.88014 -15557.972 -15514.929 100 0.01 -1 7.3731919e-09 -3.8151563e-09 1 1.9544299e-09 -767.8301 -15553.402 -15514.929 -Loop time of 6.23322 on 4 procs for 100 steps with 3456 atoms +Loop time of 4.4084 on 4 procs for 100 steps with 3456 atoms -Performance: 0.139 ns/day, 173.145 hours/ns, 16.043 timesteps/s -99.5% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 0.196 ns/day, 122.455 hours/ns, 22.684 timesteps/s +100.0% 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.6633 | 1.6906 | 1.7152 | 1.4 | 27.12 -Kspace | 0.38875 | 0.41372 | 0.44184 | 3.0 | 6.64 +Pair | 1.2326 | 1.2513 | 1.2693 | 1.3 | 28.38 +Kspace | 0.22823 | 0.24585 | 0.26385 | 2.8 | 5.58 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.05118 | 0.053267 | 0.054998 | 0.6 | 0.85 -Output | 0.0070119 | 0.0070257 | 0.0070462 | 0.0 | 0.11 -Modify | 4.0616 | 4.0629 | 4.0646 | 0.1 | 65.18 -Other | | 0.005713 | | | 0.09 +Comm | 0.025352 | 0.028409 | 0.032299 | 1.6 | 0.64 +Output | 0.001868 | 0.0018761 | 0.0018861 | 0.0 | 0.04 +Modify | 2.8753 | 2.8788 | 2.8818 | 0.1 | 65.30 +Other | | 0.002175 | | | 0.05 Nlocal: 864 ave 864 max 864 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -134,4 +134,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:06 +Total wall time: 0:00:04 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 index cee42d433b..cbc749a1f7 100644 --- a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000509977 secs + create_atoms CPU = 0.000422955 secs # setting mass, mag. moments, and interactions for bcc iron @@ -81,41 +81,41 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 7.82 | 7.82 | 7.82 Mbytes Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng Press TotEng - 0 0 0.076456975 4554.5462 100.00358 -0.85791269 3.2186929 -1070.8579 394.43342 -1067.6392 - 50 0.005 0.076456974 4658.383 96.663685 -0.86504718 3.1111957 -1070.7504 709.50826 -1067.6392 - 100 0.01 0.076456983 4744.1872 86.965803 -0.88035771 2.7990619 -1070.4383 1466.6938 -1067.6392 - 150 0.015 0.076456973 4794.5283 72.421197 -0.8996913 2.3309324 -1069.9702 2534.3867 -1067.6392 - 200 0.02 0.076456944 4707.6548 55.633188 -0.921682 1.7905973 -1069.4298 3732.183 -1067.6392 - 250 0.025 0.076456953 4439.4697 39.802206 -0.94649004 1.2810649 -1068.9203 4831.5559 -1067.6392 - 300 0.03 0.076457027 4101.6694 27.882295 -0.97253854 0.8974133 -1068.5366 5612.0928 -1067.6392 - 350 0.035 0.076457103 3860.1545 21.776538 -0.99708692 0.70089477 -1068.3401 5906.3057 -1067.6392 - 400 0.04 0.076457117 3765.5341 21.857102 -1.0190244 0.70348778 -1068.3427 5682.0053 -1067.6392 - 450 0.045 0.076457072 3739.9037 26.959407 -1.0389343 0.86770942 -1068.5069 5066.5077 -1067.6392 - 500 0.05 0.076457001 3730.8342 34.92521 -1.0582008 1.124095 -1068.7633 4279.2424 -1067.6392 - 550 0.055 0.076456962 3698.0556 43.405912 -1.0785156 1.397053 -1069.0363 3533.4153 -1067.6392 - 600 0.06 0.076456997 3560.947 50.544844 -1.102048 1.626825 -1069.2661 2975.8479 -1067.6392 - 650 0.065 0.076457079 3341.7402 55.261218 -1.1296588 1.7786252 -1069.4179 2683.3023 -1067.6392 - 700 0.07 0.076457136 3156.8448 57.25083 -1.1595102 1.8426624 -1069.4819 2640.5967 -1067.6392 - 750 0.075 0.076457132 3099.5181 56.934336 -1.1893875 1.8324758 -1069.4717 2778.3261 -1067.6392 - 800 0.08 0.076457116 3132.9985 55.266343 -1.2181223 1.7787901 -1069.418 3020.1175 -1067.6392 - 850 0.085 0.076457116 3163.2943 53.376453 -1.2443326 1.7179626 -1069.3572 3287.9042 -1067.6392 - 900 0.09 0.076457121 3168.063 52.279557 -1.2676425 1.6826581 -1069.3219 3504.7334 -1067.6392 - 950 0.095 0.076457122 3144.2102 52.667743 -1.2902335 1.6951522 -1069.3344 3622.1382 -1067.6392 - 1000 0.1 0.076457135 3061.0811 54.684094 -1.314147 1.76005 -1069.3993 3625.2935 -1067.6392 -Loop time of 2.06841 on 1 procs for 1000 steps with 250 atoms + 0 0 0.076456975 4554.5462 100.00358 -0.85791269 3.2186929 -1070.429 394.43342 -1067.2103 + 50 0.005 0.076456974 4658.383 96.663685 -0.86504718 3.1111957 -1070.3179 709.50826 -1067.2067 + 100 0.01 0.076456983 4744.1872 86.965803 -0.88035771 2.7990619 -1069.9981 1466.6938 -1067.1991 + 150 0.015 0.076456973 4794.5283 72.421197 -0.8996913 2.3309324 -1069.5203 2534.3867 -1067.1894 + 200 0.02 0.076456944 4707.6548 55.633188 -0.921682 1.7905973 -1068.969 3732.183 -1067.1784 + 250 0.025 0.076456953 4439.4697 39.802206 -0.94649004 1.2810649 -1068.447 4831.5559 -1067.166 + 300 0.03 0.076457027 4101.6694 27.882295 -0.97253854 0.8974133 -1068.0504 5612.0928 -1067.153 + 350 0.035 0.076457103 3860.1545 21.776538 -0.99708692 0.70089477 -1067.8416 5906.3057 -1067.1407 + 400 0.04 0.076457117 3765.5341 21.857102 -1.0190244 0.70348778 -1067.8332 5682.0053 -1067.1297 + 450 0.045 0.076457072 3739.9037 26.959407 -1.0389343 0.86770942 -1067.9875 5066.5077 -1067.1198 + 500 0.05 0.076457001 3730.8342 34.92521 -1.0582008 1.124095 -1068.2342 4279.2424 -1067.1101 + 550 0.055 0.076456962 3698.0556 43.405912 -1.0785156 1.397053 -1068.497 3533.4153 -1067.1 + 600 0.06 0.076456997 3560.947 50.544844 -1.102048 1.626825 -1068.715 2975.8479 -1067.0882 + 650 0.065 0.076457079 3341.7402 55.261218 -1.1296588 1.7786252 -1068.853 2683.3023 -1067.0744 + 700 0.07 0.076457136 3156.8448 57.25083 -1.1595102 1.8426624 -1068.9021 2640.5967 -1067.0595 + 750 0.075 0.076457132 3099.5181 56.934336 -1.1893875 1.8324758 -1068.877 2778.3261 -1067.0445 + 800 0.08 0.076457116 3132.9985 55.266343 -1.2181223 1.7787901 -1068.809 3020.1175 -1067.0302 + 850 0.085 0.076457116 3163.2943 53.376453 -1.2443326 1.7179626 -1068.735 3287.9042 -1067.0171 + 900 0.09 0.076457121 3168.063 52.279557 -1.2676425 1.6826581 -1068.6881 3504.7334 -1067.0054 + 950 0.095 0.076457122 3144.2102 52.667743 -1.2902335 1.6951522 -1068.6893 3622.1382 -1066.9941 + 1000 0.1 0.076457135 3061.0811 54.684094 -1.314147 1.76005 -1068.7422 3625.2935 -1066.9822 +Loop time of 1.6779 on 1 procs for 1000 steps with 250 atoms -Performance: 4.177 ns/day, 5.746 hours/ns, 483.464 timesteps/s -99.3% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 5.149 ns/day, 4.661 hours/ns, 595.982 timesteps/s +100.0% 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.96898 | 0.96898 | 0.96898 | 0.0 | 46.85 -Neigh | 0.005435 | 0.005435 | 0.005435 | 0.0 | 0.26 -Comm | 0.028027 | 0.028027 | 0.028027 | 0.0 | 1.36 -Output | 0.0051067 | 0.0051067 | 0.0051067 | 0.0 | 0.25 -Modify | 1.0569 | 1.0569 | 1.0569 | 0.0 | 51.10 -Other | | 0.003989 | | | 0.19 +Pair | 0.78285 | 0.78285 | 0.78285 | 0.0 | 46.66 +Neigh | 0.004487 | 0.004487 | 0.004487 | 0.0 | 0.27 +Comm | 0.022926 | 0.022926 | 0.022926 | 0.0 | 1.37 +Output | 0.003927 | 0.003927 | 0.003927 | 0.0 | 0.23 +Modify | 0.86033 | 0.86033 | 0.86033 | 0.0 | 51.27 +Other | | 0.003381 | | | 0.20 Nlocal: 250 ave 250 max 250 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -133,4 +133,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 index 63ddc9d4fe..a5cc9d7f0b 100644 --- a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000626087 secs + create_atoms CPU = 0.000705957 secs # setting mass, mag. moments, and interactions for bcc iron @@ -102,20 +102,20 @@ Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng Press TotEng 900 0.09 0.076457199 3228.1358 50.837416 -1.2366018 1.6362417 -1069.2755 3917.0758 -1067.6392 950 0.095 0.076457222 3247.5532 50.234549 -1.2539657 1.6168379 -1069.2561 4059.9275 -1067.6392 1000 0.1 0.076457266 3208.3875 51.592727 -1.2671834 1.6605519 -1069.2998 4001.4995 -1067.6392 -Loop time of 2.27244 on 4 procs for 1000 steps with 250 atoms +Loop time of 1.47769 on 4 procs for 1000 steps with 250 atoms -Performance: 3.802 ns/day, 6.312 hours/ns, 440.055 timesteps/s -97.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 5.847 ns/day, 4.105 hours/ns, 676.731 timesteps/s +100.0% 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.33296 | 0.37066 | 0.40364 | 4.3 | 16.31 -Neigh | 0.0013368 | 0.0025837 | 0.0056586 | 3.5 | 0.11 -Comm | 0.12627 | 0.16094 | 0.20183 | 7.1 | 7.08 -Output | 0.0033641 | 0.003438 | 0.0036473 | 0.2 | 0.15 -Modify | 1.7249 | 1.7261 | 1.7272 | 0.1 | 75.96 -Other | | 0.008682 | | | 0.38 +Pair | 0.21791 | 0.22724 | 0.23568 | 1.4 | 15.38 +Neigh | 0.001137 | 0.0011771 | 0.0012221 | 0.1 | 0.08 +Comm | 0.066727 | 0.074288 | 0.083826 | 2.3 | 5.03 +Output | 0.0017431 | 0.0017657 | 0.0018256 | 0.1 | 0.12 +Modify | 1.1707 | 1.1718 | 1.1725 | 0.1 | 79.30 +Other | | 0.001427 | | | 0.10 Nlocal: 62.5 ave 66 max 60 min Histogram: 1 0 0 2 0 0 0 0 0 1 @@ -133,4 +133,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 index 26fdfb0004..22957c8498 100644 --- a/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000481129 secs + create_atoms CPU = 0.00101709 secs # setting mass, mag. moments, and interactions for bcc iron @@ -81,41 +81,41 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 7.82 | 7.82 | 7.82 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng - 0 0 -1 0 0 1 0 -55.58269 -1125.5827 -1122.364 - 50 0.005 -1 0 0 1 0 -55.581417 -1125.4672 -1122.364 - 100 0.01 -1 0 0 1 0 -55.577759 -1125.1389 -1122.364 - 150 0.015 -1 0 0 1 0 -55.57219 -1124.6538 -1122.364 - 200 0.02 -1 0 0 1 0 -55.565438 -1124.099 -1122.364 - 250 0.025 -1 0 0 1 0 -55.558379 -1123.5779 -1122.364 - 300 0.03 -1 0 0 1 0 -55.551886 -1123.1862 -1122.364 - 350 0.035 -1 0 0 1 0 -55.546675 -1122.9858 -1122.364 - 400 0.04 -1 0 0 1 0 -55.543187 -1122.9869 -1122.364 - 450 0.045 -1 0 0 1 0 -55.54154 -1123.1498 -1122.364 - 500 0.05 -1 0 0 1 0 -55.541574 -1123.4037 -1122.364 - 550 0.055 -1 0 0 1 0 -55.542941 -1123.672 -1122.364 - 600 0.06 -1 0 0 1 0 -55.545209 -1123.8931 -1122.364 - 650 0.065 -1 0 0 1 0 -55.547951 -1124.0315 -1122.364 - 700 0.07 -1 0 0 1 0 -55.550801 -1124.0798 -1122.364 - 750 0.075 -1 0 0 1 0 -55.553483 -1124.0546 -1122.364 - 800 0.08 -1 0 0 1 0 -55.555816 -1123.9877 -1122.364 - 850 0.085 -1 0 0 1 0 -55.557706 -1123.916 -1122.364 - 900 0.09 -1 0 0 1 0 -55.55913 -1123.8714 -1122.364 - 950 0.095 -1 0 0 1 0 -55.560111 -1123.8726 -1122.364 - 1000 0.1 -1 0 0 1 0 -55.560705 -1123.9215 -1122.364 -Loop time of 1.95614 on 1 procs for 1000 steps with 250 atoms + 0 0 -1 0 0 1 0 -55.58269 -1097.7914 -1094.5727 + 50 0.005 -1 0 0 1 0 -55.581417 -1097.6764 -1094.5733 + 100 0.01 -1 0 0 1 0 -55.577759 -1097.35 -1094.5751 + 150 0.015 -1 0 0 1 0 -55.57219 -1096.8677 -1094.5779 + 200 0.02 -1 0 0 1 0 -55.565438 -1096.3163 -1094.5813 + 250 0.025 -1 0 0 1 0 -55.558379 -1095.7987 -1094.5848 + 300 0.03 -1 0 0 1 0 -55.551886 -1095.4103 -1094.5881 + 350 0.035 -1 0 0 1 0 -55.546675 -1095.2124 -1094.5907 + 400 0.04 -1 0 0 1 0 -55.543187 -1095.2153 -1094.5924 + 450 0.045 -1 0 0 1 0 -55.54154 -1095.379 -1094.5932 + 500 0.05 -1 0 0 1 0 -55.541574 -1095.633 -1094.5932 + 550 0.055 -1 0 0 1 0 -55.542941 -1095.9006 -1094.5925 + 600 0.06 -1 0 0 1 0 -55.545209 -1096.1205 -1094.5914 + 650 0.065 -1 0 0 1 0 -55.547951 -1096.2575 -1094.59 + 700 0.07 -1 0 0 1 0 -55.550801 -1096.3044 -1094.5886 + 750 0.075 -1 0 0 1 0 -55.553483 -1096.2778 -1094.5873 + 800 0.08 -1 0 0 1 0 -55.555816 -1096.2098 -1094.5861 + 850 0.085 -1 0 0 1 0 -55.557706 -1096.1372 -1094.5852 + 900 0.09 -1 0 0 1 0 -55.55913 -1096.0919 -1094.5844 + 950 0.095 -1 0 0 1 0 -55.560111 -1096.0925 -1094.584 + 1000 0.1 -1 0 0 1 0 -55.560705 -1096.1411 -1094.5837 +Loop time of 1.74825 on 1 procs for 1000 steps with 250 atoms -Performance: 4.417 ns/day, 5.434 hours/ns, 511.211 timesteps/s +Performance: 4.942 ns/day, 4.856 hours/ns, 571.999 timesteps/s 100.0% 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.90008 | 0.90008 | 0.90008 | 0.0 | 46.01 -Neigh | 0.005214 | 0.005214 | 0.005214 | 0.0 | 0.27 -Comm | 0.026026 | 0.026026 | 0.026026 | 0.0 | 1.33 -Output | 0.0045307 | 0.0045307 | 0.0045307 | 0.0 | 0.23 -Modify | 1.0168 | 1.0168 | 1.0168 | 0.0 | 51.98 -Other | | 0.003449 | | | 0.18 +Pair | 0.80384 | 0.80384 | 0.80384 | 0.0 | 45.98 +Neigh | 0.004528 | 0.004528 | 0.004528 | 0.0 | 0.26 +Comm | 0.022954 | 0.022954 | 0.022954 | 0.0 | 1.31 +Output | 0.0034568 | 0.0034568 | 0.0034568 | 0.0 | 0.20 +Modify | 0.91007 | 0.91007 | 0.91007 | 0.0 | 52.06 +Other | | 0.003404 | | | 0.19 Nlocal: 250 ave 250 max 250 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 index 2c911cb9bb..60db1064e0 100644 --- a/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000656843 secs + create_atoms CPU = 0.000651121 secs # setting mass, mag. moments, and interactions for bcc iron @@ -102,20 +102,20 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 900 0.09 -1 0 0 1 0 -55.560147 -1123.8404 -1122.364 950 0.095 -1 0 0 1 0 -55.560992 -1123.8312 -1122.364 1000 0.1 -1 0 0 1 0 -55.561635 -1123.8853 -1122.364 -Loop time of 2.38457 on 4 procs for 1000 steps with 250 atoms +Loop time of 1.5074 on 4 procs for 1000 steps with 250 atoms -Performance: 3.623 ns/day, 6.624 hours/ns, 419.362 timesteps/s -97.2% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 5.732 ns/day, 4.187 hours/ns, 663.393 timesteps/s +99.9% 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.32773 | 0.36909 | 0.41504 | 6.0 | 15.48 -Neigh | 0.0014782 | 0.0015869 | 0.001724 | 0.2 | 0.07 -Comm | 0.14716 | 0.19316 | 0.23754 | 8.4 | 8.10 -Output | 0.0030437 | 0.0032653 | 0.0035224 | 0.3 | 0.14 -Modify | 1.8109 | 1.8139 | 1.8175 | 0.2 | 76.07 -Other | | 0.003611 | | | 0.15 +Pair | 0.22156 | 0.23223 | 0.24219 | 1.5 | 15.41 +Neigh | 0.0011292 | 0.0011852 | 0.0012362 | 0.1 | 0.08 +Comm | 0.067507 | 0.076341 | 0.087237 | 2.6 | 5.06 +Output | 0.0015073 | 0.0015442 | 0.0015914 | 0.1 | 0.10 +Modify | 1.1934 | 1.1947 | 1.1955 | 0.1 | 79.25 +Other | | 0.001434 | | | 0.10 Nlocal: 62.5 ave 66 max 60 min Histogram: 1 1 0 0 0 1 0 0 0 1 @@ -136,4 +136,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 index b73f7daad7..7871d82ae9 100644 --- a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.00070715 secs + create_atoms CPU = 0.000484943 secs # setting mass, mag. moments, and interactions for cobalt @@ -81,41 +81,41 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 7.885 | 7.885 | 7.885 Mbytes Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.40997576 100.03408 -4775.0671 -2218.1018 - 50 0.005 0.028733807 0.070491717 101.47879 -28153.519 -2218.1018 - 100 0.01 0.028733815 -0.70937134 101.7311 2925.8177 -2218.1018 - 150 0.015 0.028733823 -1.853981 99.63039 1197.9339 -2218.1018 - 200 0.02 0.028733828 -3.2679239 94.850105 741.17431 -2218.1018 - 250 0.025 0.028733824 -4.863967 88.444584 550.36979 -2218.1018 - 300 0.03 0.028733807 -6.5763457 82.689581 449.78321 -2218.1018 - 350 0.035 0.028733783 -8.3489158 80.108798 384.32228 -2218.1018 - 400 0.04 0.028733763 -10.120216 82.374947 335.01545 -2218.1018 - 450 0.045 0.028733755 -11.828932 89.814597 296.88965 -2218.1018 - 500 0.05 0.028733762 -13.423712 101.39613 267.51686 -2218.1018 - 550 0.055 0.028733783 -14.866724 115.07399 244.96012 -2218.1018 - 600 0.06 0.028733801 -16.135279 128.57849 229.33327 -2218.1018 - 650 0.065 0.028733804 -17.222838 140.22402 220.05718 -2218.1018 - 700 0.07 0.028733795 -18.154813 149.61295 212.95678 -2218.1018 - 750 0.075 0.028733781 -18.996903 157.5814 206.41327 -2218.1018 - 800 0.08 0.028733768 -19.804249 164.92075 203.88977 -2218.1018 - 850 0.085 0.028733752 -20.579151 171.67278 203.42363 -2218.1018 - 900 0.09 0.028733728 -21.294277 177.67238 199.84817 -2218.1018 - 950 0.095 0.028733715 -21.943945 183.2621 194.9614 -2218.1018 - 1000 0.1 0.02873374 -22.551277 188.99284 191.59796 -2218.1018 -Loop time of 5.15676 on 1 procs for 1000 steps with 500 atoms + 0 0 0.028733803 0.40997576 100.03408 -4775.0671 -2218.3068 + 50 0.005 0.028733807 0.070491717 101.47879 -28153.519 -2218.1371 + 100 0.01 0.028733815 -0.70937134 101.7311 2925.8177 -2217.7471 + 150 0.015 0.028733823 -1.853981 99.63039 1197.9339 -2217.1748 + 200 0.02 0.028733828 -3.2679239 94.850105 741.17431 -2216.4678 + 250 0.025 0.028733824 -4.863967 88.444584 550.36979 -2215.6698 + 300 0.03 0.028733807 -6.5763457 82.689581 449.78321 -2214.8136 + 350 0.035 0.028733783 -8.3489158 80.108798 384.32228 -2213.9273 + 400 0.04 0.028733763 -10.120216 82.374947 335.01545 -2213.0417 + 450 0.045 0.028733755 -11.828932 89.814597 296.88965 -2212.1873 + 500 0.05 0.028733762 -13.423712 101.39613 267.51686 -2211.39 + 550 0.055 0.028733783 -14.866724 115.07399 244.96012 -2210.6684 + 600 0.06 0.028733801 -16.135279 128.57849 229.33327 -2210.0342 + 650 0.065 0.028733804 -17.222838 140.22402 220.05718 -2209.4904 + 700 0.07 0.028733795 -18.154813 149.61295 212.95678 -2209.0244 + 750 0.075 0.028733781 -18.996903 157.5814 206.41327 -2208.6034 + 800 0.08 0.028733768 -19.804249 164.92075 203.88977 -2208.1997 + 850 0.085 0.028733752 -20.579151 171.67278 203.42363 -2207.8122 + 900 0.09 0.028733728 -21.294277 177.67238 199.84817 -2207.4547 + 950 0.095 0.028733715 -21.943945 183.2621 194.9614 -2207.1298 + 1000 0.1 0.02873374 -22.551277 188.99284 191.59796 -2206.8262 +Loop time of 4.30614 on 1 procs for 1000 steps with 500 atoms -Performance: 1.675 ns/day, 14.324 hours/ns, 193.920 timesteps/s -99.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 2.006 ns/day, 11.961 hours/ns, 232.227 timesteps/s +100.0% 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.4083 | 2.4083 | 2.4083 | 0.0 | 46.70 -Neigh | 0.016825 | 0.016825 | 0.016825 | 0.0 | 0.33 -Comm | 0.039891 | 0.039891 | 0.039891 | 0.0 | 0.77 -Output | 0.018168 | 0.018168 | 0.018168 | 0.0 | 0.35 -Modify | 2.6657 | 2.6657 | 2.6657 | 0.0 | 51.69 -Other | | 0.007864 | | | 0.15 +Pair | 2.038 | 2.038 | 2.038 | 0.0 | 47.33 +Neigh | 0.01566 | 0.01566 | 0.01566 | 0.0 | 0.36 +Comm | 0.032802 | 0.032802 | 0.032802 | 0.0 | 0.76 +Output | 0.014146 | 0.014146 | 0.014146 | 0.0 | 0.33 +Modify | 2.2003 | 2.2003 | 2.2003 | 0.0 | 51.10 +Other | | 0.005288 | | | 0.12 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -133,4 +133,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:05 +Total wall time: 0:00:04 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 index 92bcc4f533..638ab5e635 100644 --- a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.00071907 secs + create_atoms CPU = 0.000733852 secs # setting mass, mag. moments, and interactions for cobalt @@ -102,20 +102,20 @@ Step Time v_magnorm v_emag Temp v_tmag TotEng 900 0.09 0.028733829 -21.571419 167.8571 205.79849 -2218.1018 950 0.095 0.028733825 -22.365879 175.00875 201.33088 -2218.1018 1000 0.1 0.028733821 -23.133464 184.68305 195.52912 -2218.1018 -Loop time of 3.95668 on 4 procs for 1000 steps with 500 atoms +Loop time of 2.47211 on 4 procs for 1000 steps with 500 atoms -Performance: 2.184 ns/day, 10.991 hours/ns, 252.737 timesteps/s -97.8% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 3.495 ns/day, 6.867 hours/ns, 404.513 timesteps/s +99.9% 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.89404 | 0.99018 | 1.0827 | 8.5 | 25.03 -Neigh | 0.0050189 | 0.0053826 | 0.0057576 | 0.5 | 0.14 -Comm | 0.23366 | 0.32767 | 0.42737 | 15.2 | 8.28 -Output | 0.0078192 | 0.0078953 | 0.0080998 | 0.1 | 0.20 -Modify | 2.6171 | 2.6192 | 2.6219 | 0.1 | 66.20 -Other | | 0.006363 | | | 0.16 +Pair | 0.5549 | 0.56708 | 0.58627 | 1.6 | 22.94 +Neigh | 0.0039728 | 0.0041007 | 0.0042598 | 0.2 | 0.17 +Comm | 0.087296 | 0.10802 | 0.11917 | 3.8 | 4.37 +Output | 0.0046923 | 0.0047188 | 0.0047917 | 0.1 | 0.19 +Modify | 1.7832 | 1.7862 | 1.7879 | 0.1 | 72.25 +Other | | 0.002016 | | | 0.08 Nlocal: 125 ave 139 max 112 min Histogram: 1 0 1 0 0 0 1 0 0 1 @@ -133,4 +133,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:03 +Total wall time: 0:00:02 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 index 2aa4a9a0d3..4f3b94df53 100644 --- a/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000488997 secs + create_atoms CPU = 0.00109196 secs # setting mass, mag. moments, and interactions for cobalt @@ -82,41 +82,41 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 7.885 | 7.885 | 7.885 Mbytes Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.455085 100.03408 -4301.853 -2218.0905 - 50 0.005 0.028732021 0.11535308 101.47887 -17203.944 -2218.0904 - 100 0.01 0.0287304 -0.665283 101.73105 3119.2267 -2218.09 - 150 0.015 0.028729403 -1.8105707 99.629794 1226.3803 -2218.0896 - 200 0.02 0.028731067 -3.224763 94.849715 750.93124 -2218.0895 - 250 0.025 0.028732765 -4.8207784 88.447019 555.16456 -2218.0895 - 300 0.03 0.028728169 -6.5331538 82.697813 452.6101 -2218.0896 - 350 0.035 0.02871707 -8.3059526 80.122838 386.20109 -2218.0896 - 400 0.04 0.028706605 -10.077613 82.389555 336.36118 -2218.0895 - 450 0.045 0.028701727 -11.78634 89.823176 297.91478 -2218.0894 - 500 0.05 0.028706691 -13.380919 101.39804 268.32933 -2218.0894 - 550 0.055 0.028714065 -14.824128 115.07511 245.62893 -2218.0893 - 600 0.06 0.028713691 -16.093505 128.58093 229.91054 -2218.089 - 650 0.065 0.028713232 -17.181217 140.22137 220.57591 -2218.089 - 700 0.07 0.02871245 -18.113035 149.60156 213.40077 -2218.0889 - 750 0.075 0.028712431 -18.954952 157.56849 206.80962 -2218.0891 - 800 0.08 0.02872489 -19.762756 164.91833 204.24742 -2218.0892 - 850 0.085 0.028733709 -20.538757 171.69348 203.73934 -2218.0894 - 900 0.09 0.028737031 -21.256095 177.71981 200.12043 -2218.0894 - 950 0.095 0.028743446 -21.908156 183.31613 195.23386 -2218.089 - 1000 0.1 0.028751809 -22.516179 189.01672 191.90401 -2218.0888 -Loop time of 5.71018 on 1 procs for 1000 steps with 500 atoms + 0 0 0.028733803 0.455085 100.03408 -4301.853 -2218.2955 + 50 0.005 0.028732021 0.11535308 101.47887 -17203.944 -2218.1258 + 100 0.01 0.0287304 -0.665283 101.73105 3119.2267 -2217.7358 + 150 0.015 0.028729403 -1.8105707 99.629794 1226.3803 -2217.1636 + 200 0.02 0.028731067 -3.224763 94.849715 750.93124 -2216.4566 + 250 0.025 0.028732765 -4.8207784 88.447019 555.16456 -2215.6585 + 300 0.03 0.028728169 -6.5331538 82.697813 452.6101 -2214.8022 + 350 0.035 0.02871707 -8.3059526 80.122838 386.20109 -2213.9158 + 400 0.04 0.028706605 -10.077613 82.389555 336.36118 -2213.03 + 450 0.045 0.028701727 -11.78634 89.823176 297.91478 -2212.1758 + 500 0.05 0.028706691 -13.380919 101.39804 268.32933 -2211.3785 + 550 0.055 0.028714065 -14.824128 115.07511 245.62893 -2210.6569 + 600 0.06 0.028713691 -16.093505 128.58093 229.91054 -2210.0225 + 650 0.065 0.028713232 -17.181217 140.22137 220.57591 -2209.4787 + 700 0.07 0.02871245 -18.113035 149.60156 213.40077 -2209.0127 + 750 0.075 0.028712431 -18.954952 157.56849 206.80962 -2208.5916 + 800 0.08 0.02872489 -19.762756 164.91833 204.24742 -2208.1876 + 850 0.085 0.028733709 -20.538757 171.69348 203.73934 -2207.7993 + 900 0.09 0.028737031 -21.256095 177.71981 200.12043 -2207.4406 + 950 0.095 0.028743446 -21.908156 183.31613 195.23386 -2207.1149 + 1000 0.1 0.028751809 -22.516179 189.01672 191.90401 -2206.8111 +Loop time of 4.3661 on 1 procs for 1000 steps with 500 atoms -Performance: 1.513 ns/day, 15.862 hours/ns, 175.126 timesteps/s -99.9% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 1.979 ns/day, 12.128 hours/ns, 229.037 timesteps/s +100.0% 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.7307 | 2.7307 | 2.7307 | 0.0 | 47.82 -Neigh | 0.018982 | 0.018982 | 0.018982 | 0.0 | 0.33 -Comm | 0.044032 | 0.044032 | 0.044032 | 0.0 | 0.77 -Output | 0.036037 | 0.036037 | 0.036037 | 0.0 | 0.63 -Modify | 2.8713 | 2.8713 | 2.8713 | 0.0 | 50.28 -Other | | 0.009135 | | | 0.16 +Pair | 2.0467 | 2.0467 | 2.0467 | 0.0 | 46.88 +Neigh | 0.015636 | 0.015636 | 0.015636 | 0.0 | 0.36 +Comm | 0.032918 | 0.032918 | 0.032918 | 0.0 | 0.75 +Output | 0.027737 | 0.027737 | 0.027737 | 0.0 | 0.64 +Modify | 2.2379 | 2.2379 | 2.2379 | 0.0 | 51.26 +Other | | 0.005233 | | | 0.12 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -135,4 +135,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:05 +Total wall time: 0:00:04 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 index 0657d43f8a..1724ef9df8 100644 --- a/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 @@ -19,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000617027 secs + create_atoms CPU = 0.000827074 secs # setting mass, mag. moments, and interactions for cobalt @@ -103,20 +103,20 @@ Step Time v_magnorm v_emag Temp v_tmag TotEng 900 0.09 0.028684101 -21.521505 167.76167 206.14977 -2218.089 950 0.095 0.028684705 -22.314351 174.918 201.65878 -2218.0891 1000 0.1 0.028691284 -23.080026 184.60192 195.8385 -2218.0893 -Loop time of 3.6142 on 4 procs for 1000 steps with 500 atoms +Loop time of 2.5947 on 4 procs for 1000 steps with 500 atoms -Performance: 2.391 ns/day, 10.039 hours/ns, 276.686 timesteps/s -98.8% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 3.330 ns/day, 7.207 hours/ns, 385.402 timesteps/s +99.9% 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.75407 | 0.87833 | 0.96493 | 8.8 | 24.30 -Neigh | 0.004509 | 0.0051936 | 0.0056126 | 0.6 | 0.14 -Comm | 0.19147 | 0.28312 | 0.4105 | 16.0 | 7.83 -Output | 0.013854 | 0.013948 | 0.014158 | 0.1 | 0.39 -Modify | 2.4267 | 2.4282 | 2.4319 | 0.1 | 67.19 -Other | | 0.005371 | | | 0.15 +Pair | 0.56409 | 0.58139 | 0.605 | 2.0 | 22.41 +Neigh | 0.0039618 | 0.0041058 | 0.0042889 | 0.2 | 0.16 +Comm | 0.095324 | 0.12147 | 0.13892 | 4.8 | 4.68 +Output | 0.008945 | 0.0089793 | 0.0090477 | 0.0 | 0.35 +Modify | 1.8745 | 1.8765 | 1.8795 | 0.1 | 72.32 +Other | | 0.002217 | | | 0.09 Nlocal: 125 ave 139 max 112 min Histogram: 1 0 1 0 0 0 1 0 0 1 @@ -135,4 +135,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:03 +Total wall time: 0:00:02 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 index cc1cb29a6e..d5c38a9967 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 @@ -12,7 +12,7 @@ read_data Norm_randXY_8x8x32.data 1 by 1 by 1 MPI processor grid reading atoms ... 8192 atoms - read_data CPU = 0.0207078 secs + read_data CPU = 0.0127251 secs mass 1 58.93 @@ -68,31 +68,31 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 19.68 | 19.68 | 19.68 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.0177864461018737 -1323.65841279979 1274.398774669 0 -37220.5576936917 - 10 0.001 0.0177864363786085 -1323.66900862123 1270.76616762926 0.0100007025152235 -37220.5576943558 - 20 0.002 0.0177864377251544 -1323.70032173151 1259.90270462032 0.0394803272360477 -37220.5576959255 - 30 0.003 0.0177864511986563 -1323.75117991179 1243.50772254923 0.0871132837928349 -37220.5576982168 - 40 0.004 0.0177864729727686 -1323.81992477224 1223.91535595806 0.150986538096776 -37220.5577010151 - 50 0.005 0.017786495620418 -1323.90456907402 1203.45497846157 0.22877054554493 -37220.5577041158 - 60 0.006 0.0177865119365897 -1324.00293472823 1183.95496070422 0.317876389336898 -37220.5577073311 - 70 0.007 0.0177865186121948 -1324.11277680481 1166.52445270059 0.415601818818485 -37220.5577104779 - 80 0.008 0.0177865171615599 -1324.23190710734 1151.59958937508 0.519276751090729 -37220.5577133816 - 90 0.009 0.0177865117923882 -1324.35831839963 1139.14485136813 0.626407059487507 -37220.5577158996 - 100 0.01 0.0177865063215865 -1324.49029089774 1128.88117273962 0.734797362055872 -37220.5577179524 -Loop time of 17.5042 on 1 procs for 100 steps with 8192 atoms + 0 0 0.0177864461018737 -1323.65841279979 1274.398774669 0 -36558.7284872918 + 10 0.001 0.0177864363786085 -1323.66900862123 1270.76616762926 0.0100007025152235 -36558.7231900452 + 20 0.002 0.0177864377251544 -1323.70032173151 1259.90270462032 0.0394803272360477 -36558.7075350597 + 30 0.003 0.0177864511986563 -1323.75117991179 1243.50772254923 0.0871132837928349 -36558.6821082609 + 40 0.004 0.0177864729727686 -1323.81992477224 1223.91535595806 0.150986538096776 -36558.6477386289 + 50 0.005 0.017786495620418 -1323.90456907402 1203.45497846157 0.22877054554493 -36558.6054195788 + 60 0.006 0.0177865119365897 -1324.00293472823 1183.95496070422 0.317876389336898 -36558.556239967 + 70 0.007 0.0177865186121948 -1324.11277680481 1166.52445270059 0.415601818818485 -36558.5013220755 + 80 0.008 0.0177865171615599 -1324.23190710734 1151.59958937508 0.519276751090729 -36558.4417598279 + 90 0.009 0.0177865117923882 -1324.35831839963 1139.14485136813 0.626407059487507 -36558.3785566998 + 100 0.01 0.0177865063215865 -1324.49029089774 1128.88117273962 0.734797362055872 -36558.3125725035 +Loop time of 14.8985 on 1 procs for 100 steps with 8192 atoms -Performance: 0.049 ns/day, 486.227 hours/ns, 5.713 timesteps/s -99.7% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.058 ns/day, 413.847 hours/ns, 6.712 timesteps/s +99.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 | 5.4555 | 5.4555 | 5.4555 | 0.0 | 31.17 -Neigh | 3.9944 | 3.9944 | 3.9944 | 0.0 | 22.82 -Comm | 0.086468 | 0.086468 | 0.086468 | 0.0 | 0.49 -Output | 2.7685 | 2.7685 | 2.7685 | 0.0 | 15.82 -Modify | 5.1645 | 5.1645 | 5.1645 | 0.0 | 29.50 -Other | | 0.0349 | | | 0.20 +Pair | 4.5996 | 4.5996 | 4.5996 | 0.0 | 30.87 +Neigh | 3.6 | 3.6 | 3.6 | 0.0 | 24.16 +Comm | 0.057512 | 0.057512 | 0.057512 | 0.0 | 0.39 +Output | 2.4463 | 2.4463 | 2.4463 | 0.0 | 16.42 +Modify | 4.1766 | 4.1766 | 4.1766 | 0.0 | 28.03 +Other | | 0.01854 | | | 0.12 Nlocal: 8192 ave 8192 max 8192 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -110,4 +110,4 @@ Dangerous builds not checked Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:17 +Total wall time: 0:00:15 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 index 8c477e633f..decd7f66de 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 @@ -12,7 +12,7 @@ read_data Norm_randXY_8x8x32.data 1 by 1 by 4 MPI processor grid reading atoms ... 8192 atoms - read_data CPU = 0.023248 secs + read_data CPU = 0.0103889 secs mass 1 58.93 @@ -79,20 +79,20 @@ Step Time v_magnorm v_emag v_tmag Temp TotEng 80 0.008 0.0177865881669081 -1324.23190693081 1151.59982868413 0.519276589926842 -37220.557713381 90 0.009 0.0177865780982769 -1324.35831816525 1139.14509878533 0.626406847905203 -37220.557715901 100 0.01 0.017786564605084 -1324.49029060173 1128.88143013641 0.734797098519806 -37220.557717952 -Loop time of 7.30477 on 4 procs for 100 steps with 8192 atoms +Loop time of 4.32342 on 4 procs for 100 steps with 8192 atoms -Performance: 0.118 ns/day, 202.910 hours/ns, 13.690 timesteps/s -98.0% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 0.200 ns/day, 120.095 hours/ns, 23.130 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 | 1.9727 | 2.0433 | 2.1095 | 3.9 | 27.97 -Neigh | 1.1665 | 1.3031 | 1.4137 | 8.7 | 17.84 -Comm | 0.15743 | 0.31703 | 0.53111 | 28.2 | 4.34 -Output | 1.0547 | 1.0747 | 1.094 | 1.4 | 14.71 -Modify | 2.5296 | 2.5551 | 2.5794 | 1.1 | 34.98 -Other | | 0.01167 | | | 0.16 +Pair | 1.185 | 1.1925 | 1.1991 | 0.5 | 27.58 +Neigh | 0.93459 | 0.93934 | 0.94983 | 0.6 | 21.73 +Comm | 0.042462 | 0.059373 | 0.069249 | 4.1 | 1.37 +Output | 0.61823 | 0.63273 | 0.64528 | 1.3 | 14.63 +Modify | 1.4827 | 1.4955 | 1.5099 | 0.8 | 34.59 +Other | | 0.003968 | | | 0.09 Nlocal: 2048 ave 2061 max 2035 min Histogram: 1 0 0 1 0 0 1 0 0 1 @@ -110,4 +110,4 @@ Dangerous builds not checked Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:07 +Total wall time: 0:00:04 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 index 4ca29113d3..c7544dedfa 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 @@ -16,7 +16,7 @@ WARNING: Restart file used different # of processors: 4 vs. 1 (../read_restart.c 1 by 1 by 1 MPI processor grid restoring pair style spin/exchange from restart 500 atoms - read_restart CPU = 0.000402927 secs + read_restart CPU = 0.000396967 secs # setting mass, mag. moments, and interactions @@ -74,31 +74,31 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 6.816 | 6.816 | 6.816 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 1000 0 0.108317262557656 -10.7649197733649 2538.4247868621 0 -2205.7648720089 - 1010 0.001 0.108317281393701 -10.7743543303502 2527.22692799144 0.146167392153018 -2205.76487255098 - 1020 0.002 0.108317318482233 -10.8022550516195 2509.47863584151 0.577304300153637 -2205.76487378396 - 1030 0.003 0.108317366763426 -10.8476659807571 2487.5614649682 1.27529086243277 -2205.76487555634 - 1040 0.004 0.108317415532953 -10.9092708333549 2463.97963921611 2.21443906326453 -2205.76487769286 - 1050 0.005 0.108317453851058 -10.98553406179 2440.70473642157 3.36396898978859 -2205.7648800529 - 1060 0.006 0.108317473584086 -11.0748008072977 2418.66477599297 4.68991434259399 -2205.76488256723 - 1070 0.007 0.108317471632913 -11.175325501803 2397.59274785581 6.15596240129541 -2205.76488520043 - 1080 0.008 0.108317450667394 -11.2852665400894 2376.32871275528 7.7237909750654 -2205.76488786887 - 1090 0.009 0.108317417687893 -11.4027246787047 2353.52646917989 9.35409156720424 -2205.76489041327 - 1100 0.01 0.108317381194814 -11.52585602487 2328.41541723561 11.0087303030003 -2205.76489265824 -Loop time of 1.05153 on 1 procs for 100 steps with 500 atoms + 1000 0 0.108317262557656 -10.7649197733649 2538.4247868621 0 -2200.38241212222 + 1010 0.001 0.108317281393701 -10.7743543303502 2527.22692799144 0.146167392153018 -2200.3776953858 + 1020 0.002 0.108317318482233 -10.8022550516195 2509.47863584151 0.577304300153637 -2200.36374625815 + 1030 0.003 0.108317366763426 -10.8476659807571 2487.5614649682 1.27529086243277 -2200.34104256596 + 1040 0.004 0.108317415532953 -10.9092708333549 2463.97963921611 2.21443906326453 -2200.31024227618 + 1050 0.005 0.108317453851058 -10.98553406179 2440.70473642157 3.36396898978859 -2200.27211302201 + 1060 0.006 0.108317473584086 -11.0748008072977 2418.66477599297 4.68991434259399 -2200.22748216359 + 1070 0.007 0.108317471632913 -11.175325501803 2397.59274785581 6.15596240129541 -2200.17722244953 + 1080 0.008 0.108317450667394 -11.2852665400894 2376.32871275528 7.7237909750654 -2200.12225459883 + 1090 0.009 0.108317417687893 -11.4027246787047 2353.52646917989 9.35409156720424 -2200.06352807392 + 1100 0.01 0.108317381194814 -11.52585602487 2328.41541723561 11.0087303030003 -2200.0019646458 +Loop time of 0.964681 on 1 procs for 100 steps with 500 atoms -Performance: 0.822 ns/day, 29.209 hours/ns, 95.100 timesteps/s -99.7% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.896 ns/day, 26.797 hours/ns, 103.661 timesteps/s +100.0% 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.3348 | 0.3348 | 0.3348 | 0.0 | 31.84 -Neigh | 0.26691 | 0.26691 | 0.26691 | 0.0 | 25.38 -Comm | 0.007993 | 0.007993 | 0.007993 | 0.0 | 0.76 -Output | 0.14892 | 0.14892 | 0.14892 | 0.0 | 14.16 -Modify | 0.29137 | 0.29137 | 0.29137 | 0.0 | 27.71 -Other | | 0.001526 | | | 0.15 +Pair | 0.29842 | 0.29842 | 0.29842 | 0.0 | 30.93 +Neigh | 0.25359 | 0.25359 | 0.25359 | 0.0 | 26.29 +Comm | 0.0069926 | 0.0069926 | 0.0069926 | 0.0 | 0.72 +Output | 0.14398 | 0.14398 | 0.14398 | 0.0 | 14.93 +Modify | 0.26045 | 0.26045 | 0.26045 | 0.0 | 27.00 +Other | | 0.001249 | | | 0.13 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 index 5d40efc29b..6443d341cd 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 @@ -15,7 +15,7 @@ read_restart restart_hcp_cobalt.equil 1 by 2 by 2 MPI processor grid restoring pair style spin/exchange from restart 500 atoms - read_restart CPU = 0.000858784 secs + read_restart CPU = 0.000922918 secs # setting mass, mag. moments, and interactions @@ -84,20 +84,20 @@ Step Time v_magnorm v_emag v_tmag Temp TotEng 1080 0.008 0.108317320750099 -11.2852665775656 2376.32820919279 7.7237915384778 -2205.76488786888 1090 0.009 0.108317304079233 -11.402724701646 2353.52588586648 9.35409189724323 -2205.7648904133 1100 0.01 0.108317284409678 -11.5258560062539 2328.41472376239 11.0087299868288 -2205.76489265829 -Loop time of 0.603216 on 4 procs for 100 steps with 500 atoms +Loop time of 0.410707 on 4 procs for 100 steps with 500 atoms -Performance: 1.432 ns/day, 16.756 hours/ns, 165.778 timesteps/s -99.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 2.104 ns/day, 11.409 hours/ns, 243.483 timesteps/s +99.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.1203 | 0.12952 | 0.13546 | 1.6 | 21.47 -Neigh | 0.064357 | 0.080477 | 0.093005 | 4.4 | 13.34 -Comm | 0.016533 | 0.035739 | 0.06195 | 9.9 | 5.92 -Output | 0.063324 | 0.065044 | 0.066794 | 0.5 | 10.78 -Modify | 0.29023 | 0.29189 | 0.29336 | 0.3 | 48.39 -Other | | 0.0005503 | | | 0.09 +Pair | 0.083043 | 0.083714 | 0.084202 | 0.1 | 20.38 +Neigh | 0.063158 | 0.064429 | 0.065314 | 0.3 | 15.69 +Comm | 0.012237 | 0.013588 | 0.014798 | 0.8 | 3.31 +Output | 0.039088 | 0.040653 | 0.042176 | 0.6 | 9.90 +Modify | 0.20645 | 0.20795 | 0.20945 | 0.2 | 50.63 +Other | | 0.0003724 | | | 0.09 Nlocal: 125 ave 127 max 122 min Histogram: 1 0 0 0 1 0 0 0 0 2 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 index 986f93e3e1..9dbe1a3548 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 @@ -18,7 +18,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.001122 secs + create_atoms CPU = 0.000552893 secs # setting mass, mag. moments, and interactions for cobalt @@ -72,31 +72,31 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 6.947 | 6.947 | 6.947 Mbytes Step Time v_magnorm v_emag Temp TotEng - 0 0 0.076558814 1.7982359 0 1.7982359 - 100 0.01 0.077628154 0.73387834 0 0.73387834 - 200 0.02 0.076678996 -0.4048463 0 -0.4048463 - 300 0.03 0.079174837 -1.3519103 0 -1.3519103 - 400 0.04 0.085031632 -3.0345702 0 -3.0345702 - 500 0.05 0.08702747 -4.0853256 0 -4.0853256 - 600 0.06 0.087066482 -5.259549 0 -5.259549 - 700 0.07 0.089788894 -6.629076 0 -6.629076 - 800 0.08 0.091699611 -8.0574087 0 -8.0574087 - 900 0.09 0.090038899 -9.2012019 0 -9.2012019 - 1000 0.1 0.093257309 -10.470452 0 -10.470452 -Loop time of 3.56687 on 1 procs for 1000 steps with 500 atoms + 0 0 0.076558814 1.7982359 0 0.89911794 + 100 0.01 0.077628154 0.73387834 0 0.36693917 + 200 0.02 0.076678996 -0.4048463 0 -0.20242315 + 300 0.03 0.079174837 -1.3519103 0 -0.67595514 + 400 0.04 0.085031632 -3.0345702 0 -1.5172851 + 500 0.05 0.08702747 -4.0853256 0 -2.0426628 + 600 0.06 0.087066482 -5.259549 0 -2.6297745 + 700 0.07 0.089788894 -6.629076 0 -3.314538 + 800 0.08 0.091699611 -8.0574087 0 -4.0287043 + 900 0.09 0.090038899 -9.2012019 0 -4.600601 + 1000 0.1 0.093257309 -10.470452 0 -5.2352261 +Loop time of 3.37852 on 1 procs for 1000 steps with 500 atoms -Performance: 2.422 ns/day, 9.908 hours/ns, 280.358 timesteps/s -99.3% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 2.557 ns/day, 9.385 hours/ns, 295.987 timesteps/s +99.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 | 0.46568 | 0.46568 | 0.46568 | 0.0 | 13.06 +Pair | 0.45808 | 0.45808 | 0.45808 | 0.0 | 13.56 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.022188 | 0.022188 | 0.022188 | 0.0 | 0.62 -Output | 1.4417 | 1.4417 | 1.4417 | 0.0 | 40.42 -Modify | 1.6335 | 1.6335 | 1.6335 | 0.0 | 45.80 -Other | | 0.003845 | | | 0.11 +Comm | 0.019707 | 0.019707 | 0.019707 | 0.0 | 0.58 +Output | 1.3865 | 1.3865 | 1.3865 | 0.0 | 41.04 +Modify | 1.5106 | 1.5106 | 1.5106 | 0.0 | 44.71 +Other | | 0.003624 | | | 0.11 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 index 05f6091f79..cb98274603 100644 --- a/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 @@ -18,7 +18,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000901937 secs + create_atoms CPU = 0.000751972 secs # setting mass, mag. moments, and interactions for cobalt @@ -83,20 +83,20 @@ Step Time v_magnorm v_emag Temp TotEng 800 0.08 0.097960611 -7.8688568 0 -7.8688568 900 0.09 0.10193463 -9.5888008 0 -9.5888008 1000 0.1 0.10831726 -10.76492 0 -10.76492 -Loop time of 2.36594 on 4 procs for 1000 steps with 500 atoms +Loop time of 1.70473 on 4 procs for 1000 steps with 500 atoms -Performance: 3.652 ns/day, 6.572 hours/ns, 422.665 timesteps/s -98.9% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 5.068 ns/day, 4.735 hours/ns, 586.602 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.13515 | 0.15276 | 0.16507 | 2.8 | 6.46 +Pair | 0.11636 | 0.11927 | 0.12069 | 0.5 | 7.00 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.08478 | 0.10161 | 0.12408 | 4.5 | 4.29 -Output | 0.50658 | 0.52938 | 0.55066 | 2.3 | 22.38 -Modify | 1.5629 | 1.5794 | 1.6014 | 1.3 | 66.75 -Other | | 0.002834 | | | 0.12 +Comm | 0.049208 | 0.052445 | 0.057424 | 1.4 | 3.08 +Output | 0.38579 | 0.40345 | 0.4199 | 2.0 | 23.67 +Modify | 1.1138 | 1.1282 | 1.1436 | 1.1 | 66.18 +Other | | 0.001322 | | | 0.08 Nlocal: 125 ave 125 max 125 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -116,4 +116,4 @@ write_restart restart_hcp_cobalt.equil Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:02 +Total wall time: 0:00:01 diff --git a/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 index da8e705204..ed5c037feb 100644 --- a/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 +++ b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 @@ -18,10 +18,10 @@ region reg1 block 0.0 10.0 0.0 5.0 0.0 1.0 region reg2 block 0.0 10.0 6.0 10.0 0.0 1.0 create_atoms 1 region reg1 Created 120 atoms - create_atoms CPU = 0.000591993 secs + create_atoms CPU = 0.000998974 secs create_atoms 2 region reg2 Created 80 atoms - create_atoms CPU = 2.19345e-05 secs + create_atoms CPU = 4.1008e-05 secs # setting mass, mag. moments, and interactions for bcc iron @@ -88,25 +88,25 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 7.215 | 7.215 | 7.215 Mbytes Step Time v_magx v_magz v_magnorm v_tmag TotEng - 0 0 0.000143282585570239 0.615515043943419 0.615726279597251 21.735436446264 0.251043691626527 - 100 0.01 -0.00116085697754605 0.590264559350799 0.590315072966953 0.00283413081085227 0.0846048989956838 - 200 0.02 -0.00014757052323624 0.5896197627388 0.589686497206689 0.000451051163122381 0.0839054390713707 - 300 0.03 2.64982966536903e-05 0.590029694756149 0.590102003120244 5.22539631503911e-05 0.0838351677819021 - 400 0.04 1.77805448780044e-05 0.590195117338991 0.590268726215095 4.46490059775722e-06 0.0838382933245033 - 500 0.05 6.71566571038784e-06 0.590243842081075 0.590317756995865 3.63227563542099e-07 0.0838411433938002 - 600 0.06 2.24103407431009e-06 0.590257551861528 0.590331542128336 2.99360370345602e-08 0.0838420708305254 - 700 0.07 7.12179152899672e-07 0.5902614042958 0.590335413637883 2.51559188415894e-09 0.0838423375091772 - 800 0.08 2.20574733078571e-07 0.590262494529884 0.590336508799302 2.14455748236281e-10 0.0838424126463501 - 900 0.09 6.72564339382342e-08 0.590262805532644 0.590336821097688 1.84495767133404e-11 0.0838424338620733 - 1000 0.1 2.03001940418668e-08 0.590262894882646 0.590336910794094 1.5958531383517e-12 0.0838424398944954 -Loop time of 0.128906 on 1 procs for 1000 steps with 200 atoms + 0 0 0.000143282585570239 0.615515043943419 0.615726279597251 24.9364200982478 0.121881906963737 + 100 0.01 0.000616167502203097 0.594467364025194 0.594498630048783 0.00188964439583802 0.0371335982020527 + 200 0.02 0.000498981016106215 0.595175581059792 0.595218717456538 0.000158614984300385 0.036877233648055 + 300 0.03 0.000211899815837572 0.595357874794342 0.595402442288391 1.44454891242177e-05 0.0368548794182375 + 400 0.04 7.98967577397158e-05 0.595395828381057 0.595440657806237 1.50721782707597e-06 0.0368527556548781 + 500 0.05 2.9121648914103e-05 0.595403174462525 0.595448064489507 1.74330474543395e-07 0.0368525254239539 + 600 0.06 1.04772320898497e-05 0.595404457003426 0.595449362424563 2.12204214498221e-08 0.0368524982492743 + 700 0.07 3.74634771616422e-06 0.595404627382825 0.595449536940641 2.63852407890463e-09 0.036852494912626 + 800 0.08 1.33525617457914e-06 0.595404626884198 0.595449537611055 3.30772506699851e-10 0.0368524944963445 + 900 0.09 4.75054785504803e-07 0.595404613763238 0.595449524836571 4.15940445257144e-11 0.0368524944440918 + 1000 0.1 1.68843135202601e-07 0.59540460640039 0.595449517580793 5.23632581178917e-12 0.036852494437518 +Loop time of 0.0966749 on 1 procs for 1000 steps with 200 atoms -98.9% CPU use with 1 MPI tasks x no OpenMP threads +100.0% CPU use with 1 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations Energy initial, next-to-last, final = - 0.251043691627 0.0838424398641 0.0838424398945 + 0.121881906964 0.0368524944375 0.0368524944375 Force two-norm initial, final = 0 0 Force max component initial, final = 0 0 Final line search alpha, max atom move = 0 0 @@ -115,12 +115,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.11267 | 0.11267 | 0.11267 | 0.0 | 87.41 +Pair | 0.08679 | 0.08679 | 0.08679 | 0.0 | 89.77 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.00012422 | 0.00012422 | 0.00012422 | 0.0 | 0.10 -Output | 0.0062549 | 0.0062549 | 0.0062549 | 0.0 | 4.85 -Modify | 0.0036588 | 0.0036588 | 0.0036588 | 0.0 | 2.84 -Other | | 0.006197 | | | 4.81 +Comm | 7.2956e-05 | 7.2956e-05 | 7.2956e-05 | 0.0 | 0.08 +Output | 0.0033231 | 0.0033231 | 0.0033231 | 0.0 | 3.44 +Modify | 0.0022919 | 0.0022919 | 0.0022919 | 0.0 | 2.37 +Other | | 0.004197 | | | 4.34 Nlocal: 200 ave 200 max 200 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 index 4889232f9d..4ce1497957 100644 --- a/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 +++ b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 @@ -18,10 +18,10 @@ region reg1 block 0.0 10.0 0.0 5.0 0.0 1.0 region reg2 block 0.0 10.0 6.0 10.0 0.0 1.0 create_atoms 1 region reg1 Created 120 atoms - create_atoms CPU = 0.000560045 secs + create_atoms CPU = 0.000770092 secs create_atoms 2 region reg2 Created 80 atoms - create_atoms CPU = 0.000101089 secs + create_atoms CPU = 7.9155e-05 secs # setting mass, mag. moments, and interactions for bcc iron @@ -99,9 +99,9 @@ Step Time v_magx v_magz v_magnorm v_tmag TotEng 800 0.08 2.20574733079126e-07 0.590262494529884 0.590336508799302 2.14455748236281e-10 0.0838424126463497 900 0.09 6.72564339365689e-08 0.590262805532644 0.590336821097688 1.84495767133404e-11 0.0838424338620728 1000 0.1 2.03001940390912e-08 0.590262894882646 0.590336910794094 1.5958531383517e-12 0.0838424398944951 -Loop time of 0.0892034 on 4 procs for 1000 steps with 200 atoms +Loop time of 0.0617704 on 4 procs for 1000 steps with 200 atoms -91.7% CPU use with 4 MPI tasks x no OpenMP threads +98.7% CPU use with 4 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations @@ -115,12 +115,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.032445 | 0.038594 | 0.054315 | 4.6 | 43.27 +Pair | 0.023753 | 0.029762 | 0.035936 | 3.3 | 48.18 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.020121 | 0.035668 | 0.042827 | 4.8 | 39.98 -Output | 0.0024662 | 0.0025705 | 0.0028648 | 0.3 | 2.88 -Modify | 0.00099444 | 0.0010954 | 0.0011995 | 0.2 | 1.23 -Other | | 0.01128 | | | 12.64 +Comm | 0.011783 | 0.019131 | 0.025404 | 4.3 | 30.97 +Output | 0.0019517 | 0.0019774 | 0.0020368 | 0.1 | 3.20 +Modify | 0.0006361 | 0.00087249 | 0.0011525 | 0.0 | 1.41 +Other | | 0.01003 | | | 16.23 Nlocal: 50 ave 50 max 50 min Histogram: 4 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 index 134ff82ea0..61b6ad8700 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.00103712 secs + create_atoms CPU = 0.00107217 secs # setting mass, mag. moments, and interactions for bcc iron @@ -88,35 +88,35 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 8.331 | 8.331 | 8.331 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.0100717228668283 -0.162177519662199 14970.7090923449 0 -0.157514482753568 - 50 0.005 0.00013406177065452 -128.226118665465 0.102634444037433 0 -128.28618242467 - 100 0.01 7.67769618983783e-06 -131.374599259781 0.0222596977749883 0 -131.428418504308 - 150 0.015 6.02904602224617e-07 -132.224372015825 0.00974271828169067 0 -132.273190134603 - 200 0.02 6.50197247050607e-07 -132.573383315469 0.00374227079785919 0 -132.617565541035 - 250 0.025 4.40534385751331e-07 -132.729743470508 0.00193340972825779 0 -132.770567114743 - 300 0.03 2.78356316513452e-07 -132.819255077939 0.00124938353773497 0 -132.857574876413 - 350 0.035 1.79684785125462e-07 -132.882714312877 0.000973166792896161 0 -132.919261229743 - 400 0.04 1.10949878458879e-07 -132.935357748213 0.000852955460997589 0 -132.970786605995 - 450 0.045 6.49064465617783e-08 -132.982991683198 0.000790741148426227 0 -133.017887798926 - 500 0.05 3.70514666560433e-08 -133.027689959766 0.000747949132882749 0 -133.062561991888 - 550 0.055 2.12433814830335e-08 -133.070148920145 0.000712637321271171 0 -133.105417593747 - 600 0.06 1.24676590173818e-08 -133.110772798502 0.000685051841817329 0 -133.146767469277 - 650 0.065 7.53611859123344e-09 -133.150126417754 0.000669443562813207 0 -133.187094895709 - 700 0.07 4.63539338668379e-09 -133.189024073453 0.000669619853917951 0 -133.227152349437 - 750 0.075 2.82145833993213e-09 -133.22844627026 0.00068733803508696 0 -133.267881315199 - 800 0.08 1.64378151551878e-09 -133.269413776733 0.00072219769217513 0 -133.310284062462 - 850 0.085 8.88331010921243e-10 -133.312863108453 0.000771645398804489 0 -133.355293578462 - 900 0.09 4.33874801673642e-10 -133.359507749172 0.000830255722998153 0 -133.403626236688 - 950 0.095 1.88127849216404e-10 -133.409630495316 0.000888348219681115 0 -133.455560507802 - 1000 0.1 7.17748877096286e-11 -133.462806227865 0.000931427722404679 0 -133.510640942679 -Loop time of 11.213 on 1 procs for 1000 steps with 5780 atoms + 0 0 0.0100717228668283 -0.163834417271778 14831.3069413956 0 -0.0819172086358848 + 50 0.005 0.000106105812337003 -128.307447484203 0.104264818055985 0 -64.1537237421011 + 100 0.01 7.95347901119144e-06 -131.449389798071 0.0221943604064967 0 -65.7246948990356 + 150 0.015 5.63006161138875e-07 -132.296453030419 0.0085472877724348 0 -66.1482265152089 + 200 0.02 5.07390677383517e-07 -132.622857703805 0.00361380451198708 0 -66.3114288519012 + 250 0.025 3.28458336892231e-07 -132.774411992703 0.00187753161968493 0 -66.3872059963511 + 300 0.03 1.93294839202864e-07 -132.861283726084 0.00121374398924599 0 -66.4306418630428 + 350 0.035 1.13872157437693e-07 -132.923137019136 0.000954736871701507 0 -66.4615685095675 + 400 0.04 6.42075545620808e-08 -132.975239148591 0.000854064736183609 0 -66.4876195742954 + 450 0.045 3.44210513403008e-08 -133.023523287306 0.000812909459005007 0 -66.5117616436536 + 500 0.05 1.80394981485933e-08 -133.070071976252 0.000789742875305133 0 -66.5350359881254 + 550 0.055 9.54697157105863e-09 -133.11541233939 0.000769860218895372 0 -66.5577061696963 + 600 0.06 5.22455110720346e-09 -133.159676447906 0.000752941158466282 0 -66.5798382239526 + 650 0.065 2.95172977724016e-09 -133.203196195612 0.000745065216626277 0 -66.6015980978057 + 700 0.07 1.6727567441294e-09 -133.246696814329 0.000752898926000619 0 -66.6233484071653 + 750 0.075 9.17127001723567e-10 -133.291227007554 0.000780491405791262 0 -66.6456135037769 + 800 0.08 4.72669535949609e-10 -133.337962593396 0.000827942834401386 0 -66.6689812966976 + 850 0.085 2.25696738407094e-10 -133.387945245851 0.000890246383931885 0 -66.6939726229243 + 900 0.09 1.0030717061716e-10 -133.441737087546 0.000955403731484674 0 -66.720868543773 + 950 0.095 4.19867626359036e-11 -133.498969798312 0.00100352240545389 0 -66.7494848991554 + 1000 0.1 1.64283478182092e-11 -133.557979904763 0.00101162410316333 0 -66.7789899523816 +Loop time of 9.23057 on 1 procs for 1000 steps with 5780 atoms -99.7% CPU use with 1 MPI tasks x no OpenMP threads +99.9% CPU use with 1 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations Energy initial, next-to-last, final = - -0.157514482754 -133.509516066 -133.510640943 + -0.0819172086359 -66.778399627 -66.7789899524 Force two-norm initial, final = 0 0 Force max component initial, final = 0 0 Final line search alpha, max atom move = 0 0 @@ -125,12 +125,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 10.611 | 10.611 | 10.611 | 0.0 | 94.63 +Pair | 8.7576 | 8.7576 | 8.7576 | 0.0 | 94.88 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.048211 | 0.048211 | 0.048211 | 0.0 | 0.43 -Output | 0.37333 | 0.37333 | 0.37333 | 0.0 | 3.33 -Modify | 0.038759 | 0.038759 | 0.038759 | 0.0 | 0.35 -Other | | 0.1419 | | | 1.27 +Comm | 0.023815 | 0.023815 | 0.023815 | 0.0 | 0.26 +Output | 0.31665 | 0.31665 | 0.31665 | 0.0 | 3.43 +Modify | 0.029446 | 0.029446 | 0.029446 | 0.0 | 0.32 +Other | | 0.1031 | | | 1.12 Nlocal: 5780 ave 5780 max 5780 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -145,4 +145,4 @@ Total # of neighbors = 92480 Ave neighs/atom = 16 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:11 +Total wall time: 0:00:09 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 index 16e51bd17a..efc4628b9e 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 2 by 2 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.00216103 secs + create_atoms CPU = 0.00102711 secs # setting mass, mag. moments, and interactions for bcc iron @@ -109,9 +109,9 @@ Step Time v_magnorm v_emag v_tmag Temp TotEng 900 0.09 4.33874801863461e-10 -133.359507749172 0.000830255722998156 0 -133.403626236688 950 0.095 1.8812784924272e-10 -133.409630495316 0.000888348219681112 0 -133.455560507802 1000 0.1 7.17748875671948e-11 -133.462806227865 0.000931427722404681 0 -133.510640942679 -Loop time of 3.46778 on 4 procs for 1000 steps with 5780 atoms +Loop time of 2.53419 on 4 procs for 1000 steps with 5780 atoms -99.2% CPU use with 4 MPI tasks x no OpenMP threads +99.9% CPU use with 4 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations @@ -125,12 +125,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 2.4063 | 2.831 | 3.0798 | 15.5 | 81.64 +Pair | 2.2697 | 2.2995 | 2.3564 | 2.2 | 90.74 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.21179 | 0.45698 | 0.87844 | 38.4 | 13.18 -Output | 0.1139 | 0.11396 | 0.11409 | 0.0 | 3.29 -Modify | 0.0079708 | 0.0099814 | 0.011315 | 1.2 | 0.29 -Other | | 0.05581 | | | 1.61 +Comm | 0.05711 | 0.11414 | 0.14368 | 10.1 | 4.50 +Output | 0.084883 | 0.084915 | 0.084985 | 0.0 | 3.35 +Modify | 0.0071826 | 0.0072024 | 0.0072234 | 0.0 | 0.28 +Other | | 0.02847 | | | 1.12 Nlocal: 1445 ave 1445 max 1445 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -145,4 +145,4 @@ Total # of neighbors = 92480 Ave neighs/atom = 16 Neighbor list builds = 0 Dangerous builds = 0 -Total wall time: 0:00:03 +Total wall time: 0:00:02 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 index 0687081521..ffd244b146 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.00103903 secs + create_atoms CPU = 0.00135589 secs # setting mass, mag. moments, and interactions for bcc iron @@ -88,25 +88,25 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 8.331 | 8.331 | 8.331 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.0100717228668283 -0.162177519662199 14970.7090923449 0 -0.157514482753568 - 100 0.01 8.97646420937928e-06 -132.756468673032 0.00226858475243124 0 -132.798812395869 - 200 0.02 5.70496744394871e-06 -133.065966570145 0.000924384747875191 0 -133.105411060402 - 300 0.03 7.08166486347207e-06 -133.359072681024 0.00128114254070689 0 -133.406669528642 - 400 0.04 4.6022497035281e-06 -133.668643035704 0.00082233479844806 0 -133.725353643023 - 500 0.05 3.13737045264263e-06 -133.819548711647 0.00036967841746145 0 -133.878037514586 - 600 0.06 2.55239214470191e-06 -133.889302880669 0.000169614248283497 0 -133.948327309748 - 700 0.07 1.92236411979773e-06 -133.920147501261 7.31985644003828e-05 0 -133.979597440787 - 800 0.08 1.40879742056288e-06 -133.933445418833 3.19349095035102e-05 0 -133.993344750158 - 900 0.09 1.02629246258505e-06 -133.939321574068 1.44399877051466e-05 0 -133.999611147323 - 1000 0.1 7.52253147839439e-07 -133.942032102451 6.85789018963958e-06 0 -134.002604512511 -Loop time of 10.4788 on 1 procs for 1000 steps with 5780 atoms + 0 0 0.0100717228668283 -0.163834417271778 14831.3069413956 0 -0.0819172086358848 + 100 0.01 8.80197005314557e-06 -132.80634639767 0.00226660536216922 0 -66.4031731988347 + 200 0.02 6.70903250218956e-06 -133.127078243354 0.00103783628361662 0 -66.563539121677 + 300 0.03 4.5381603452565e-06 -133.471076972345 0.00144833375067451 0 -66.7355384861738 + 400 0.04 9.04820921016732e-07 -133.767843456662 0.000682239601485924 0 -66.8839217283314 + 500 0.05 1.6866160174916e-06 -133.893922160731 0.00032462625992713 0 -66.946961080365 + 600 0.06 1.78038217785001e-06 -133.957222680701 0.000160730704849448 0 -66.9786113403509 + 700 0.07 1.49199057723078e-06 -133.987255887786 7.39864656758093e-05 0 -66.9936279438931 + 800 0.08 1.15173756711067e-06 -134.000921126053 3.33959465206462e-05 0 -67.0004605630278 + 900 0.09 8.48526364752965e-07 -134.007049858868 1.49345737358251e-05 0 -67.0035249294347 + 1000 0.1 6.10346492876059e-07 -134.009791515671 6.71648807105468e-06 0 -67.0048957578347 +Loop time of 9.4449 on 1 procs for 1000 steps with 5780 atoms -99.9% CPU use with 1 MPI tasks x no OpenMP threads +100.0% CPU use with 1 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations Energy initial, next-to-last, final = - -0.157514482754 -134.00257032 -134.002604513 + -0.0819172086359 -67.0048809251 -67.0048957578 Force two-norm initial, final = 0 0 Force max component initial, final = 0 0 Final line search alpha, max atom move = 2.122e-314 0 @@ -115,12 +115,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 9.7413 | 9.7413 | 9.7413 | 0.0 | 92.96 +Pair | 8.7686 | 8.7686 | 8.7686 | 0.0 | 92.84 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.033583 | 0.033583 | 0.033583 | 0.0 | 0.32 -Output | 0.33068 | 0.33068 | 0.33068 | 0.0 | 3.16 -Modify | 0.033124 | 0.033124 | 0.033124 | 0.0 | 0.32 -Other | | 0.3401 | | | 3.25 +Comm | 0.02386 | 0.02386 | 0.02386 | 0.0 | 0.25 +Output | 0.31808 | 0.31808 | 0.31808 | 0.0 | 3.37 +Modify | 0.029416 | 0.029416 | 0.029416 | 0.0 | 0.31 +Other | | 0.305 | | | 3.23 Nlocal: 5780 ave 5780 max 5780 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -138,4 +138,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:10 +Total wall time: 0:00:09 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 index b1dfabd35e..730bf477d4 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) 2 by 2 by 1 MPI processor grid create_atoms 1 box Created 5780 atoms - create_atoms CPU = 0.000909805 secs + create_atoms CPU = 0.00138712 secs # setting mass, mag. moments, and interactions for bcc iron @@ -99,9 +99,9 @@ Step Time v_magnorm v_emag v_tmag Temp TotEng 800 0.08 1.40879742055238e-06 -133.933445418833 3.19349095035109e-05 0 -133.993344750158 900 0.09 1.02629246257047e-06 -133.939321574068 1.44399877051467e-05 0 -133.999611147322 1000 0.1 7.52253147824893e-07 -133.942032102451 6.85789018963965e-06 0 -134.002604512509 -Loop time of 4.52508 on 4 procs for 1000 steps with 5780 atoms +Loop time of 2.49676 on 4 procs for 1000 steps with 5780 atoms -97.3% CPU use with 4 MPI tasks x no OpenMP threads +100.0% CPU use with 4 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations @@ -115,12 +115,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 2.7814 | 3.2998 | 3.808 | 25.6 | 72.92 +Pair | 2.2509 | 2.2589 | 2.2629 | 0.3 | 90.47 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.37682 | 0.87552 | 1.3847 | 48.7 | 19.35 -Output | 0.1621 | 0.16349 | 0.16483 | 0.3 | 3.61 -Modify | 0.0099754 | 0.012567 | 0.014974 | 2.1 | 0.28 -Other | | 0.1737 | | | 3.84 +Comm | 0.06036 | 0.064254 | 0.072356 | 1.9 | 2.57 +Output | 0.084002 | 0.085009 | 0.085985 | 0.3 | 3.40 +Modify | 0.0072496 | 0.0072694 | 0.0073116 | 0.0 | 0.29 +Other | | 0.08134 | | | 3.26 Nlocal: 1445 ave 1445 max 1445 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -138,4 +138,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:04 +Total wall time: 0:00:02 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 index b13ce090e4..a8685eb2cf 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 3.96) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 1156 atoms - create_atoms CPU = 0.000702858 secs + create_atoms CPU = 0.00136805 secs # setting mass, mag. moments, and interactions for bcc iron @@ -89,36 +89,36 @@ Neighbor list info ... bin: none Per MPI rank memory allocation (min/avg/max) = 7.748 | 7.748 | 7.748 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.0205636053306396 -0.217760509274283 1541.29975585881 0 -0.21723077139301 - 50 0.005 0.000966655616832908 -19.2878369426356 0.312860071233838 0 -19.3229939390148 - 100 0.01 0.00154452800146007 -19.5948898197921 0.365367666925721 0 -19.6389064900417 - 150 0.015 4.90329738897855e-05 -19.6962578948663 0.000386378108166462 0 -19.704713985757 - 200 0.02 1.39636819172648e-06 -19.6975289055185 6.05740522809686e-05 0 -19.7059135025107 - 250 0.025 7.30255912392386e-08 -19.6975359463778 7.86050372080572e-09 0 -19.7059189975433 - 300 0.03 2.3618265959146e-09 -19.6975359475117 1.36402599486317e-13 0 -19.70591910974 - 347 0.0347 1.42160367645076e-11 -19.6975359475123 2.85504863224395e-16 0 -19.7059191162178 -Loop time of 0.427798 on 1 procs for 347 steps with 1156 atoms + 0 0 0.0205636053306396 -0.218504643888467 1537.40479337332 0 -0.109252321944233 + 50 0.005 0.000800557938107919 -19.2937186217138 0.293526226015746 0 -9.65918446070018 + 100 0.01 0.000434178067296136 -19.6225314972776 0.136842093090897 0 -9.81803976806459 + 150 0.015 9.48307628510239e-06 -19.7062424007137 0.000835148627123792 0 -9.85315267460932 + 200 0.02 9.40072944704056e-06 -19.7072931204571 7.72334770010361e-06 0 -9.85364693487844 + 250 0.025 5.05117500164935e-07 -19.7072952885901 5.72437821949831e-08 0 -9.85364764712939 + 300 0.03 2.15063977474981e-09 -19.707295295749 2.09970244523395e-12 0 -9.8536476478746 + 303 0.0303 1.43831710574092e-09 -19.7072952957498 1.70336397715489e-13 0 -9.85364764787493 +Loop time of 0.335897 on 1 procs for 303 steps with 1156 atoms -99.9% CPU use with 1 MPI tasks x no OpenMP threads +100.0% CPU use with 1 MPI tasks x no OpenMP threads Minimization stats: - Stopping criterion = force tolerance + Stopping criterion = energy tolerance Energy initial, next-to-last, final = - -0.217230771393 -19.7059191162 -19.7059191162 + -0.109252321944 -9.85364764787 -9.85364764787 Force two-norm initial, final = 0 0 Force max component initial, final = 0 0 Final line search alpha, max atom move = 0 0 - Iterations, force evaluations = 347 347 + Iterations, force evaluations = 303 303 MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.36166 | 0.36166 | 0.36166 | 0.0 | 84.54 +Pair | 0.28129 | 0.28129 | 0.28129 | 0.0 | 83.74 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0016549 | 0.0016549 | 0.0016549 | 0.0 | 0.39 -Output | 0.02019 | 0.02019 | 0.02019 | 0.0 | 4.72 -Modify | 0.0024493 | 0.0024493 | 0.0024493 | 0.0 | 0.57 -Other | | 0.04184 | | | 9.78 +Comm | 0.0010796 | 0.0010796 | 0.0010796 | 0.0 | 0.32 +Output | 0.017942 | 0.017942 | 0.017942 | 0.0 | 5.34 +Modify | 0.001771 | 0.001771 | 0.001771 | 0.0 | 0.53 +Other | | 0.03382 | | | 10.07 Nlocal: 1156 ave 1156 max 1156 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 index 2a5917663e..f2756d0f5e 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (134.64 134.64 3.96) 2 by 2 by 1 MPI processor grid create_atoms 1 box Created 1156 atoms - create_atoms CPU = 0.000618935 secs + create_atoms CPU = 0.000981808 secs # setting mass, mag. moments, and interactions for bcc iron @@ -97,9 +97,9 @@ Step Time v_magnorm v_emag v_tmag Temp TotEng 250 0.025 5.21141123128679e-08 -19.6975359469038 2.52554968535685e-09 0 -19.7059189333986 300 0.03 2.9845103782958e-09 -19.6975359475094 2.31782597655471e-11 0 -19.7059191124033 342 0.0342 1.0526549233076e-10 -19.6975359475123 3.65641352240487e-16 0 -19.7059191178145 -Loop time of 0.234594 on 4 procs for 342 steps with 1156 atoms +Loop time of 0.117672 on 4 procs for 342 steps with 1156 atoms -93.1% CPU use with 4 MPI tasks x no OpenMP threads +99.4% CPU use with 4 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = force tolerance @@ -113,12 +113,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.097515 | 0.12325 | 0.15193 | 7.4 | 52.54 +Pair | 0.084558 | 0.086668 | 0.091471 | 1.0 | 73.65 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.038284 | 0.061142 | 0.081045 | 8.1 | 26.06 -Output | 0.008667 | 0.0086921 | 0.0087271 | 0.0 | 3.71 -Modify | 0.00063705 | 0.00084341 | 0.0010526 | 0.0 | 0.36 -Other | | 0.04067 | | | 17.34 +Comm | 0.0052197 | 0.010042 | 0.012191 | 2.8 | 8.53 +Output | 0.0050647 | 0.0050726 | 0.0050921 | 0.0 | 4.31 +Modify | 0.00052595 | 0.00053537 | 0.00055242 | 0.0 | 0.45 +Other | | 0.01535 | | | 13.05 Nlocal: 289 ave 289 max 289 min Histogram: 4 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 index 637c624a7c..6df5959c0b 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.00061512 secs + create_atoms CPU = 0.000965834 secs # setting mass, mag. moments, and interactions for bcc iron @@ -76,25 +76,25 @@ Neighbor list info ... bin: standard Per MPI rank memory allocation (min/avg/max) = 6.848 | 6.848 | 6.848 Mbytes Step Time v_magx v_magz v_magnorm v_tmag TotEng - 0 0 -0.0285071136621457 -0.00948990815281275 0.0764569750905723 5048.56076237679 -0.701465876910694 - 100 0.01 -0.584953861980204 -0.0517163256267969 0.999992350892306 6.25556948778472e-05 -50.578744362023 - 200 0.02 -0.584864756506845 -0.0547143484057153 0.999999990495506 3.49782260454062e-06 -50.5787971409244 - 300 0.03 -0.5847600493607 -0.0578846348986585 0.999999999988174 3.83095226805016e-06 -50.5788061208586 - 400 0.04 -0.584642875238893 -0.0612373075362701 0.999999999999986 4.28575832708226e-06 -50.5788161053511 - 500 0.05 -0.584511765589529 -0.0647826190376231 1 4.79421486949086e-06 -50.5788272748485 - 600 0.06 -0.584365074206159 -0.0685313536438759 1 5.36242072641834e-06 -50.5788397688161 - 700 0.07 -0.584200963215273 -0.072494846958872 1 5.99725249459222e-06 -50.5788537427261 - 800 0.08 -0.584017381477007 -0.0766850043611195 0.999999999999999 6.70634191991825e-06 -50.5788693699026 - 900 0.09 -0.583812040722351 -0.0811143180675364 0.999999999999999 7.49814943594148e-06 -50.5788868434701 - 1000 0.1 -0.583582389243979 -0.0857958823565731 0.999999999999998 8.38204259112222e-06 -50.5789063784909 -Loop time of 0.215249 on 1 procs for 1000 steps with 250 atoms + 0 0 -0.0285071136621457 -0.00948990815281275 0.0764569750905723 5048.56076237679 -0.354774619362398 + 100 0.01 -0.584953861980204 -0.0517163256267969 0.999992350892306 6.25556948778472e-05 -25.2894057771132 + 200 0.02 -0.584864756506845 -0.0547143484057153 0.999999990495506 3.49782260454062e-06 -25.289435991418 + 300 0.03 -0.5847600493607 -0.0578846348986585 0.999999999988174 3.83095226805016e-06 -25.2894449433165 + 400 0.04 -0.584642875238893 -0.0612373075362701 0.999999999999986 4.28575832708226e-06 -25.2894549277735 + 500 0.05 -0.584511765589529 -0.0647826190376231 1 4.79421486949086e-06 -25.2894660972709 + 600 0.06 -0.584365074206159 -0.0685313536438759 1 5.36242072641834e-06 -25.2894785912384 + 700 0.07 -0.584200963215273 -0.072494846958872 1 5.99725249459222e-06 -25.2894925651485 + 800 0.08 -0.584017381477007 -0.0766850043611195 0.999999999999999 6.70634191991825e-06 -25.289508192325 + 900 0.09 -0.583812040722351 -0.0811143180675364 0.999999999999999 7.49814943594148e-06 -25.2895256658925 + 1000 0.1 -0.583582389243979 -0.0857958823565731 0.999999999999998 8.38204259112222e-06 -25.2895452009133 +Loop time of 0.195254 on 1 procs for 1000 steps with 250 atoms 100.0% CPU use with 1 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations Energy initial, next-to-last, final = - -0.701465876911 -50.5789061722 -50.5789063785 + -0.354774619362 -25.2895449946 -25.2895452009 Force two-norm initial, final = 0 0 Force max component initial, final = 0 0 Final line search alpha, max atom move = 0 0 @@ -103,12 +103,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.19278 | 0.19278 | 0.19278 | 0.0 | 89.56 +Pair | 0.17668 | 0.17668 | 0.17668 | 0.0 | 90.49 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.0062225 | 0.0062225 | 0.0062225 | 0.0 | 2.89 -Output | 0.0085046 | 0.0085046 | 0.0085046 | 0.0 | 3.95 -Modify | 0.0017273 | 0.0017273 | 0.0017273 | 0.0 | 0.80 -Other | | 0.006012 | | | 2.79 +Comm | 0.0052176 | 0.0052176 | 0.0052176 | 0.0 | 2.67 +Output | 0.0067751 | 0.0067751 | 0.0067751 | 0.0 | 3.47 +Modify | 0.0013788 | 0.0013788 | 0.0013788 | 0.0 | 0.71 +Other | | 0.005203 | | | 2.66 Nlocal: 250 ave 250 max 250 min Histogram: 1 0 0 0 0 0 0 0 0 0 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 index 70f395ab08..b0cdd4f94a 100644 --- a/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 +++ b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 @@ -17,7 +17,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000644922 secs + create_atoms CPU = 0.000759125 secs # setting mass, mag. moments, and interactions for bcc iron @@ -87,9 +87,9 @@ Step Time v_magx v_magz v_magnorm v_tmag TotEng 800 0.08 -0.584017381477007 -0.0766850043611196 1 6.7063419199184e-06 -50.5788693699014 900 0.09 -0.583812040722352 -0.0811143180675365 0.999999999999998 7.49814943594153e-06 -50.5788868434688 1000 0.1 -0.583582389243979 -0.0857958823565732 0.999999999999999 8.38204259112203e-06 -50.5789063784897 -Loop time of 0.229203 on 4 procs for 1000 steps with 250 atoms +Loop time of 0.0845464 on 4 procs for 1000 steps with 250 atoms -85.9% CPU use with 4 MPI tasks x no OpenMP threads +99.8% CPU use with 4 MPI tasks x no OpenMP threads Minimization stats: Stopping criterion = max iterations @@ -103,12 +103,12 @@ Minimization stats: MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 0.06774 | 0.080677 | 0.097769 | 4.4 | 35.20 +Pair | 0.043007 | 0.045307 | 0.04776 | 0.8 | 53.59 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.10574 | 0.11072 | 0.11498 | 1.0 | 48.31 -Output | 0.0061452 | 0.0061803 | 0.0062776 | 0.1 | 2.70 -Modify | 0.00074291 | 0.00096381 | 0.0014563 | 0.0 | 0.42 -Other | | 0.03066 | | | 13.38 +Comm | 0.026827 | 0.029139 | 0.031438 | 1.0 | 34.47 +Output | 0.0023198 | 0.0023302 | 0.0023572 | 0.0 | 2.76 +Modify | 0.00041103 | 0.0004673 | 0.00054026 | 0.0 | 0.55 +Other | | 0.007303 | | | 8.64 Nlocal: 62.5 ave 65 max 60 min Histogram: 2 0 0 0 0 0 0 0 0 2 diff --git a/examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py b/examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py index a8639925f6..dd1c543bb3 100755 --- a/examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py +++ b/examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py @@ -65,8 +65,6 @@ for t in range (0,N): # calc. average magnetization Sm = (S1+S2)*0.5 # calc. energy - # en = -hbar*(np.dot(S1,wf1)+np.dot(S2,wf2)) - en = -2.0*J0*(np.dot(S1,S2)) + en = -J0*(np.dot(S1,S2)) # print res. in ps for comparison with LAMMPS print(t*dt/1000.0,Sm[0],Sm[1],Sm[2],en) - # print(t*dt/1000.0,S1[0],S2[0],S1[1],S2[1],S1[2],S2[2],en) diff --git a/examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py b/examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py index 6c8afca569..bbc7c8f54e 100755 --- a/examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py +++ b/examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py @@ -15,7 +15,7 @@ if len(argv) != 3: lammps_file = sys.argv[1] llg_file = sys.argv[2] -t_lmp,Sx_lmp,Sy_lmp,Sz_lmp,e_lmp = np.loadtxt(lammps_file,skiprows=0, usecols=(1,2,3,4,5),unpack=True) +t_lmp,Sx_lmp,Sy_lmp,Sz_lmp,e_lmp = np.loadtxt(lammps_file,skiprows=0, usecols=(1,2,3,4,7),unpack=True) t_llg,Sx_llg,Sy_llg,Sz_llg,e_llg = np.loadtxt(llg_file,skiprows=0, usecols=(0,1,2,3,4),unpack=True) plt.figure() diff --git a/examples/SPIN/test_problems/validation_damped_exchange/run-bench-exchange.sh b/examples/SPIN/test_problems/validation_damped_exchange/run-test-exchange.sh similarity index 100% rename from examples/SPIN/test_problems/validation_damped_exchange/run-bench-exchange.sh rename to examples/SPIN/test_problems/validation_damped_exchange/run-test-exchange.sh diff --git a/examples/SPIN/test_problems/validation_damped_exchange/two_spins.data b/examples/SPIN/test_problems/validation_damped_exchange/two_spins.data deleted file mode 100644 index 013f813751..0000000000 --- a/examples/SPIN/test_problems/validation_damped_exchange/two_spins.data +++ /dev/null @@ -1,22 +0,0 @@ -LAMMPS data file via write_data, version 19 Sep 2019, timestep = 0 - -2 atoms -1 atom types - -0.0 6.0 xlo xhi -0.0 3.0 ylo yhi -0.0 3.0 zlo zhi - -Masses - -1 1 - -Atoms # spin - -1 1 2.0 0.0 0.0 0.0 1.0 0.0 0.0 0 0 0 -2 1 2.0 3.0 0.0 0.0 0.0 1.0 0.0 0 0 0 - -Velocities - -1 0.0 0.0 0.0 -2 0.0 0.0 0.0 diff --git a/examples/SPIN/test_problems/validation_damped_precession/run-bench-prec.sh b/examples/SPIN/test_problems/validation_damped_precession/run-test-prec.sh similarity index 100% rename from examples/SPIN/test_problems/validation_damped_precession/run-bench-prec.sh rename to examples/SPIN/test_problems/validation_damped_precession/run-test-prec.sh diff --git a/examples/SPIN/test_problems/validation_langevin_precession/run-bench-prec.sh b/examples/SPIN/test_problems/validation_langevin_precession/run-test-prec.sh similarity index 100% rename from examples/SPIN/test_problems/validation_langevin_precession/run-bench-prec.sh rename to examples/SPIN/test_problems/validation_langevin_precession/run-test-prec.sh diff --git a/src/SPIN/atom_vec_spin.cpp b/src/SPIN/atom_vec_spin.cpp index ad1384ffd2..28c52bb39d 100644 --- a/src/SPIN/atom_vec_spin.cpp +++ b/src/SPIN/atom_vec_spin.cpp @@ -848,17 +848,16 @@ void AtomVecSpin::data_atom(double *coord, imageint imagetmp, char **values) int AtomVecSpin::data_atom_hybrid(int nlocal, char **values) { - - 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); + sp[nlocal][3] = utils::numeric(FLERR,values[0],true,lmp); + sp[nlocal][0] = utils::numeric(FLERR,values[1],true,lmp); + sp[nlocal][1] = utils::numeric(FLERR,values[2],true,lmp); + sp[nlocal][2] = utils::numeric(FLERR,values[3],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] = utils::numeric(FLERR,values[3],true,lmp); return 4; } diff --git a/src/SPIN/pair_spin_dipole_long.cpp b/src/SPIN/pair_spin_dipole_long.cpp index 356f73a809..124522a9b9 100644 --- a/src/SPIN/pair_spin_dipole_long.cpp +++ b/src/SPIN/pair_spin_dipole_long.cpp @@ -296,7 +296,7 @@ void PairSpinDipoleLong::compute(int eflag, int vflag) if (rsq <= local_cut2) { evdwl -= spi[0]*fmi[0] + spi[1]*fmi[1] + spi[2]*fmi[2]; - evdwl *= hbar; + evdwl *= 0.5*hbar; } } else evdwl = 0.0; From 65381d7a690d5c82c72eb9de575afea252f2f189 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sun, 24 Nov 2019 18:11:35 -0700 Subject: [PATCH 500/557] Add new table_from_list extension --- doc/src/_ext/table_from_list.py | 56 +++++++++++++++++++++++++++++++++ doc/utils/sphinx-config/conf.py | 5 ++- 2 files changed, 60 insertions(+), 1 deletion(-) create mode 100644 doc/src/_ext/table_from_list.py diff --git a/doc/src/_ext/table_from_list.py b/doc/src/_ext/table_from_list.py new file mode 100644 index 0000000000..44c85fc378 --- /dev/null +++ b/doc/src/_ext/table_from_list.py @@ -0,0 +1,56 @@ +from docutils import nodes +from sphinx.util.docutils import SphinxDirective +from docutils.nodes import Element, Node +from typing import Any, Dict, List +from sphinx import addnodes +from sphinx.util import logging + +class TableFromList(SphinxDirective): + has_content = True + required_arguments = 0 + optional_arguments = 0 + final_argument_whitespace = False + option_spec = { + 'columns': int, + } + + def run(self) -> List[Node]: + ncolumns = self.options.get('columns', 2) + node = addnodes.compact_paragraph() + node.document = self.state.document + self.state.nested_parse(self.content, self.content_offset, node) + if len(node.children) != 1 or not isinstance(node.children[0], + nodes.bullet_list): + reporter = self.state.document.reporter + return [reporter.warning('.. table_from_list content is not a list', line=self.lineno)] + fulllist = node.children[0] + table = nodes.table() + tgroup = nodes.tgroup(cols=ncolumns) + table += tgroup + + for i in range(ncolumns): + tgroup += nodes.colspec(colwidth=1) + + tbody = nodes.tbody() + tgroup += tbody + current_row = nodes.row() + + for idx, cell in enumerate(fulllist.children): + if len(current_row.children) == ncolumns: + tbody += current_row + current_row = nodes.row() + entry = nodes.entry() + current_row += entry + if len(cell.children) > 0: + entry += cell.children[0] + + tbody += current_row + return [table] + +def setup(app): + app.add_directive("table_from_list", TableFromList) + return { + 'version': '0.1', + 'parallel_read_safe': True, + 'parallel_write_safe': True, + } diff --git a/doc/utils/sphinx-config/conf.py b/doc/utils/sphinx-config/conf.py index 70a96e1614..0b6dfcca2d 100644 --- a/doc/utils/sphinx-config/conf.py +++ b/doc/utils/sphinx-config/conf.py @@ -20,6 +20,7 @@ import os # add these directories to sys.path here. If the directory is relative to the # documentation root, use os.path.abspath to make it absolute, like shown here. #sys.path.insert(0, os.path.abspath('.')) +sys.path.append(os.path.join(os.path.dirname(__file__), '../../src/_ext')) # -- General configuration ------------------------------------------------ @@ -30,7 +31,9 @@ import os # extensions coming with Sphinx (named 'sphinx.ext.*') or your custom # ones. extensions = [ - 'sphinx.ext.mathjax', 'sphinx.ext.imgmath' + 'sphinx.ext.mathjax', + 'sphinx.ext.imgmath', + 'table_from_list', ] # 2017-12-07: commented out, since this package is broken with Sphinx 16.x # yet we can no longer use Sphinx 15.x, since that breaks with From 2c33b5589df13ad6f6bf20413e009c72a197c97d Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sun, 24 Nov 2019 18:12:24 -0700 Subject: [PATCH 501/557] Remove txt/Commands*.txt --- doc/txt/Commands.txt | 60 -------- doc/txt/Commands_all.txt | 139 ------------------ doc/txt/Commands_bond.txt | 148 ------------------- doc/txt/Commands_category.txt | 141 ------------------ doc/txt/Commands_compute.txt | 166 --------------------- doc/txt/Commands_fix.txt | 240 ------------------------------- doc/txt/Commands_kspace.txt | 37 ----- doc/txt/Commands_pair.txt | 253 --------------------------------- doc/txt/Commands_removed.txt | 66 --------- doc/txt/Commands_structure.txt | 95 ------------- 10 files changed, 1345 deletions(-) delete mode 100644 doc/txt/Commands.txt delete mode 100644 doc/txt/Commands_all.txt delete mode 100644 doc/txt/Commands_bond.txt delete mode 100644 doc/txt/Commands_category.txt delete mode 100644 doc/txt/Commands_compute.txt delete mode 100644 doc/txt/Commands_fix.txt delete mode 100644 doc/txt/Commands_kspace.txt delete mode 100644 doc/txt/Commands_pair.txt delete mode 100644 doc/txt/Commands_removed.txt delete mode 100644 doc/txt/Commands_structure.txt diff --git a/doc/txt/Commands.txt b/doc/txt/Commands.txt deleted file mode 100644 index bcbbe524a8..0000000000 --- a/doc/txt/Commands.txt +++ /dev/null @@ -1,60 +0,0 @@ -"Previous Section"_Run_head.html - "LAMMPS WWW Site"_lws - -"LAMMPS Documentation"_ld - "LAMMPS Commands"_lc - "Next -Section"_Packages.html :c - -:link(lws,http://lammps.sandia.gov) -:link(ld,Manual.html) -:link(lc,Commands_all.html#comm) - -:line - -Commands :h2 - -These pages describe how a LAMMPS input script is formatted and the -commands in it are used to define a LAMMPS simulation. - - - - - -"LAMMPS input scripts"_Commands_input.html -"Parsing rules for input scripts"_Commands_parse.html -"Input script structure"_Commands_structure.html -"Commands by category"_Commands_category.html :all(b) - -"General commands"_Commands_all.html -"Fix commands"_Commands_fix.html -"Compute commands"_Commands_compute.html -"Pair commands"_Commands_pair.html -"Bond, angle, dihedral, improper commands"_Commands_bond.html -"KSpace solvers"_Commands_kspace.html :all(b) - -"Removed commands and packages"_Commands_removed.html :all(b) - - - diff --git a/doc/txt/Commands_all.txt b/doc/txt/Commands_all.txt deleted file mode 100644 index ecd21e42e7..0000000000 --- a/doc/txt/Commands_all.txt +++ /dev/null @@ -1,139 +0,0 @@ -"Higher level section"_Commands.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 - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -General commands :h3 - -An alphabetic list of all general LAMMPS commands. - -"angle_coeff"_angle_coeff.html, -"angle_style"_angle_style.html, -"atom_modify"_atom_modify.html, -"atom_style"_atom_style.html, -"balance"_balance.html, -"bond_coeff"_bond_coeff.html, -"bond_style"_bond_style.html, -"bond_write"_bond_write.html, -"boundary"_boundary.html, -"box"_box.html, -"change_box"_change_box.html, -"clear"_clear.html, -"comm_modify"_comm_modify.html, -"comm_style"_comm_style.html, -"compute"_compute.html, -"compute_modify"_compute_modify.html, -"create_atoms"_create_atoms.html, -"create_bonds"_create_bonds.html, -"create_box"_create_box.html, -"delete_atoms"_delete_atoms.html, -"delete_bonds"_delete_bonds.html, -"dielectric"_dielectric.html, -"dihedral_coeff"_dihedral_coeff.html, -"dihedral_style"_dihedral_style.html, -"dimension"_dimension.html, -"displace_atoms"_displace_atoms.html, -"dump"_dump.html, -"dump adios"_dump_adios.html, -"dump image"_dump_image.html, -"dump movie"_dump_image.html, -"dump netcdf"_dump_netcdf.html, -"dump netcdf/mpiio"_dump_netcdf.html, -"dump vtk"_dump_vtk.html, -"dump_modify"_dump_modify.html, -"dynamical_matrix"_dynamical_matrix.html, -"echo"_echo.html, -"fix"_fix.html, -"fix_modify"_fix_modify.html, -"group"_group.html, -"group2ndx"_group2ndx.html, -"hyper"_hyper.html, -"if"_if.html, -"info"_info.html, -"improper_coeff"_improper_coeff.html, -"improper_style"_improper_style.html, -"include"_include.html, -"jump"_jump.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, -"lattice"_lattice.html, -"log"_log.html, -"mass"_mass.html, -"message"_message.html, -"minimize"_minimize.html, -"min_modify"_min_modify.html, -"min_style"_min_style.html, -"min_style spin"_min_spin.html, -"molecule"_molecule.html, -"ndx2group"_group2ndx.html, -"neb"_neb.html, -"neb/spin"_neb_spin.html, -"neigh_modify"_neigh_modify.html, -"neighbor"_neighbor.html, -"newton"_newton.html, -"next"_next.html, -"package"_package.html, -"pair_coeff"_pair_coeff.html, -"pair_modify"_pair_modify.html, -"pair_style"_pair_style.html, -"pair_write"_pair_write.html, -"partition"_partition.html, -"prd"_prd.html, -"print"_print.html, -"processors"_processors.html, -"python"_python.html, -"quit"_quit.html, -"read_data"_read_data.html, -"read_dump"_read_dump.html, -"read_restart"_read_restart.html, -"region"_region.html, -"replicate"_replicate.html, -"rerun"_rerun.html, -"reset_ids"_reset_ids.html, -"reset_timestep"_reset_timestep.html, -"restart"_restart.html, -"run"_run.html, -"run_style"_run_style.html, -"server"_server.html, -"set"_set.html, -"shell"_shell.html, -"special_bonds"_special_bonds.html, -"suffix"_suffix.html, -"tad"_tad.html, -"temper"_temper.html, -"temper/grem"_temper_grem.html, -"temper/npt"_temper_npt.html, -"thermo"_thermo.html, -"thermo_modify"_thermo_modify.html, -"thermo_style"_thermo_style.html, -"third_order"_third_order.html, -"timer"_timer.html, -"timestep"_timestep.html, -"uncompute"_uncompute.html, -"undump"_undump.html, -"unfix"_unfix.html, -"units"_units.html, -"variable"_variable.html, -"velocity"_velocity.html, -"write_coeff"_write_coeff.html, -"write_data"_write_data.html, -"write_dump"_write_dump.html, -"write_restart"_write_restart.html :tb(c=6,ea=c) diff --git a/doc/txt/Commands_bond.txt b/doc/txt/Commands_bond.txt deleted file mode 100644 index aecbf4cca0..0000000000 --- a/doc/txt/Commands_bond.txt +++ /dev/null @@ -1,148 +0,0 @@ -"Higher level section"_Commands.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) - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html#bond, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -Bond, angle, dihedral, and improper commands :h3 - -:line - -Bond_style potentials :h3,link(bond) - -All LAMMPS "bond_style"_bond_style.html commands. Some styles have -accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"none"_bond_none.html, -"zero"_bond_zero.html, -"hybrid"_bond_hybrid.html, -, -, -, -, -, -"class2 (ko)"_bond_class2.html, -"fene (iko)"_bond_fene.html, -"fene/expand (o)"_bond_fene_expand.html, -"gromos (o)"_bond_gromos.html, -"harmonic (iko)"_bond_harmonic.html, -"harmonic/shift (o)"_bond_harmonic_shift.html, -"harmonic/shift/cut (o)"_bond_harmonic_shift_cut.html, -"mm3"_bond_mm3.html, -"morse (o)"_bond_morse.html, -"nonlinear (o)"_bond_nonlinear.html, -"oxdna/fene"_bond_oxdna.html, -"oxdna2/fene"_bond_oxdna.html, -"quartic (o)"_bond_quartic.html, -"table (o)"_bond_table.html :tb(c=4,ea=c) - -:line - -Angle_style potentials :h3,link(angle) - -All LAMMPS "angle_style"_angle_style.html commands. Some styles have -accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"none"_angle_none.html, -"zero"_angle_zero.html, -"hybrid"_angle_hybrid.html, -, -, -, -, -, -"charmm (iko)"_angle_charmm.html, -"class2 (ko)"_angle_class2.html, -"class2/p6"_angle_class2.html, -"cosine (ko)"_angle_cosine.html, -"cosine/buck6d"_angle_cosine_buck6d.html, -"cosine/delta (o)"_angle_cosine_delta.html, -"cosine/periodic (o)"_angle_cosine_periodic.html, -"cosine/shift (o)"_angle_cosine_shift.html, -"cosine/shift/exp (o)"_angle_cosine_shift_exp.html, -"cosine/squared (o)"_angle_cosine_squared.html, -"cross"_angle_cross.html, -"dipole (o)"_angle_dipole.html, -"fourier (o)"_angle_fourier.html, -"fourier/simple (o)"_angle_fourier_simple.html, -"harmonic (iko)"_angle_harmonic.html, -"mm3"_angle_mm3.html, -"quartic (o)"_angle_quartic.html, -"sdk (o)"_angle_sdk.html, -"table (o)"_angle_table.html :tb(c=4,ea=c) - -:line - -Dihedral_style potentials :h3,link(dihedral) - -All LAMMPS "dihedral_style"_dihedral_style.html commands. Some styles -have accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"none"_dihedral_none.html, -"zero"_dihedral_zero.html, -"hybrid"_dihedral_hybrid.html, -, -, -, -, -, -"charmm (iko)"_dihedral_charmm.html, -"charmmfsw"_dihedral_charmm.html, -"class2 (ko)"_dihedral_class2.html, -"cosine/shift/exp (o)"_dihedral_cosine_shift_exp.html, -"fourier (io)"_dihedral_fourier.html, -"harmonic (iko)"_dihedral_harmonic.html, -"helix (o)"_dihedral_helix.html, -"multi/harmonic (o)"_dihedral_multi_harmonic.html, -"nharmonic (o)"_dihedral_nharmonic.html, -"opls (iko)"_dihedral_opls.html, -"quadratic (o)"_dihedral_quadratic.html, -"spherical"_dihedral_spherical.html, -"table (o)"_dihedral_table.html, -"table/cut"_dihedral_table_cut.html :tb(c=4,ea=c) - -:line - -Improper_style potentials :h3,link(improper) - -All LAMMPS "improper_style"_improper_style.html commands. Some styles -have accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"none"_improper_none.html, -"zero"_improper_zero.html, -"hybrid"_improper_hybrid.html, -, -, -, -, -, -"class2 (ko)"_improper_class2.html, -"cossq (o)"_improper_cossq.html, -"cvff (io)"_improper_cvff.html, -"distance"_improper_distance.html, -"distharm"_improper_distharm.html, -"fourier (o)"_improper_fourier.html, -"harmonic (iko)"_improper_harmonic.html, -"inversion/harmonic"_improper_inversion_harmonic.html, -"ring (o)"_improper_ring.html, -"sqdistharm"_improper_sqdistharm.html, -"umbrella (o)"_improper_umbrella.html :tb(c=4,ea=c) diff --git a/doc/txt/Commands_category.txt b/doc/txt/Commands_category.txt deleted file mode 100644 index 14a328b227..0000000000 --- a/doc/txt/Commands_category.txt +++ /dev/null @@ -1,141 +0,0 @@ -"Higher level section"_Commands.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 - -Commands by category :h3 - -This page lists most of the LAMMPS commands, grouped by category. The -"General commands"_Commands_all.html doc page lists all general commands -alphabetically. Style options for entries like fix, compute, pair etc. -have their own pages where they are listed alphabetically. - -Initialization: - -"newton"_newton.html, -"package"_package.html, -"processors"_processors.html, -"suffix"_suffix.html, -"units"_units.html :ul - -Setup simulation box: - -"boundary"_boundary.html, -"box"_box.html, -"change_box"_change_box.html, -"create_box"_create_box.html, -"dimension"_dimension.html, -"lattice"_lattice.html, -"region"_region.html :ul - -Setup atoms: - -"atom_modify"_atom_modify.html, -"atom_style"_atom_style.html, -"balance"_balance.html, -"create_atoms"_create_atoms.html, -"create_bonds"_create_bonds.html, -"delete_atoms"_delete_atoms.html, -"delete_bonds"_delete_bonds.html, -"displace_atoms"_displace_atoms.html, -"group"_group.html, -"mass"_mass.html, -"molecule"_molecule.html, -"read_data"_read_data.html, -"read_dump"_read_dump.html, -"read_restart"_read_restart.html, -"replicate"_replicate.html, -"set"_set.html, -"velocity"_velocity.html :ul - -Force fields: - -"angle_coeff"_angle_coeff.html, -"angle_style"_angle_style.html, -"bond_coeff"_bond_coeff.html, -"bond_style"_bond_style.html, -"bond_write"_bond_write.html, -"dielectric"_dielectric.html, -"dihedral_coeff"_dihedral_coeff.html, -"dihedral_style"_dihedral_style.html, -"improper_coeff"_improper_coeff.html, -"improper_style"_improper_style.html, -"kspace_modify"_kspace_modify.html, -"kspace_style"_kspace_style.html, -"pair_coeff"_pair_coeff.html, -"pair_modify"_pair_modify.html, -"pair_style"_pair_style.html, -"pair_write"_pair_write.html, -"special_bonds"_special_bonds.html :ul - -Settings: - -"comm_modify"_comm_modify.html, -"comm_style"_comm_style.html, -"info"_info.html, -"min_modify"_min_modify.html, -"min_style"_min_style.html, -"neigh_modify"_neigh_modify.html, -"neighbor"_neighbor.html, -"partition"_partition.html, -"reset_timestep"_reset_timestep.html, -"run_style"_run_style.html, -"timer"_timer.html, -"timestep"_timestep.html :ul - -Operations within timestepping (fixes) and diagnostics (computes): - -"compute"_compute.html, -"compute_modify"_compute_modify.html, -"fix"_fix.html, -"fix_modify"_fix_modify.html, -"uncompute"_uncompute.html, -"unfix"_unfix.html :ul - -Output: - -"dump image"_dump_image.html, -"dump movie"_dump_image.html, -"dump"_dump.html, -"dump_modify"_dump_modify.html, -"restart"_restart.html, -"thermo"_thermo.html, -"thermo_modify"_thermo_modify.html, -"thermo_style"_thermo_style.html, -"undump"_undump.html, -"write_coeff"_write_coeff.html, -"write_data"_write_data.html, -"write_dump"_write_dump.html, -"write_restart"_write_restart.html :ul - -Actions: - -"minimize"_minimize.html, -"neb"_neb.html, -"neb_spin"_neb_spin.html, -"prd"_prd.html, -"rerun"_rerun.html, -"run"_run.html, -"tad"_tad.html, -"temper"_temper.html :ul - -Input script control: - -"clear"_clear.html, -"echo"_echo.html, -"if"_if.html, -"include"_include.html, -"jump"_jump.html, -"label"_label.html, -"log"_log.html, -"next"_next.html, -"print"_print.html, -"python"_python.html, -"quit"_quit.html, -"shell"_shell.html, -"variable"_variable.html :ul - diff --git a/doc/txt/Commands_compute.txt b/doc/txt/Commands_compute.txt deleted file mode 100644 index caf627188b..0000000000 --- a/doc/txt/Commands_compute.txt +++ /dev/null @@ -1,166 +0,0 @@ -"Higher level section"_Commands.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 - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -Compute commands :h3 - -An alphabetic list of all LAMMPS "compute"_compute.html commands. -Some styles have accelerated versions. This is indicated by -additional letters in parenthesis: g = GPU, i = USER-INTEL, k = -KOKKOS, o = USER-OMP, t = OPT. - -"ackland/atom"_compute_ackland_atom.html, -"adf"_compute_adf.html, -"aggregate/atom"_compute_cluster_atom.html, -"angle"_compute_angle.html, -"angle/local"_compute_angle_local.html, -"angmom/chunk"_compute_angmom_chunk.html, -"basal/atom"_compute_basal_atom.html, -"body/local"_compute_body_local.html, -"bond"_compute_bond.html, -"bond/local"_compute_bond_local.html, -"centro/atom"_compute_centro_atom.html, -"centroid/stress/atom"_compute_stress_atom.html, -"chunk/atom"_compute_chunk_atom.html, -"chunk/spread/atom"_compute_chunk_spread_atom.html, -"cluster/atom"_compute_cluster_atom.html, -"cna/atom"_compute_cna_atom.html, -"cnp/atom"_compute_cnp_atom.html, -"com"_compute_com.html, -"com/chunk"_compute_com_chunk.html, -"contact/atom"_compute_contact_atom.html, -"coord/atom"_compute_coord_atom.html, -"damage/atom"_compute_damage_atom.html, -"dihedral"_compute_dihedral.html, -"dihedral/local"_compute_dihedral_local.html, -"dilatation/atom"_compute_dilatation_atom.html, -"dipole/chunk"_compute_dipole_chunk.html, -"displace/atom"_compute_displace_atom.html, -"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, -"erotate/rigid"_compute_erotate_rigid.html, -"erotate/sphere"_compute_erotate_sphere.html, -"erotate/sphere/atom"_compute_erotate_sphere_atom.html, -"event/displace"_compute_event_displace.html, -"fep"_compute_fep.html, -"force/tally"_compute_tally.html, -"fragment/atom"_compute_cluster_atom.html, -"global/atom"_compute_global_atom.html, -"group/group"_compute_group_group.html, -"gyration"_compute_gyration.html, -"gyration/chunk"_compute_gyration_chunk.html, -"gyration/shape"_compute_gyration_shape.html, -"gyration/shape/chunk"_compute_gyration_shape_chunk.html, -"heat/flux"_compute_heat_flux.html, -"heat/flux/tally"_compute_tally.html, -"hexorder/atom"_compute_hexorder_atom.html, -"hma"_compute_hma.html, -"improper"_compute_improper.html, -"improper/local"_compute_improper_local.html, -"inertia/chunk"_compute_inertia_chunk.html, -"ke"_compute_ke.html, -"ke/atom"_compute_ke_atom.html, -"ke/atom/eff"_compute_ke_atom_eff.html, -"ke/eff"_compute_ke_eff.html, -"ke/rigid"_compute_ke_rigid.html, -"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, -"omega/chunk"_compute_omega_chunk.html, -"orientorder/atom"_compute_orientorder_atom.html, -"pair"_compute_pair.html, -"pair/local"_compute_pair_local.html, -"pe"_compute_pe.html, -"pe/atom"_compute_pe_atom.html, -"pe/mol/tally"_compute_tally.html, -"pe/tally"_compute_tally.html, -"plasticity/atom"_compute_plasticity_atom.html, -"pressure"_compute_pressure.html, -"pressure/cylinder"_compute_pressure_cylinder.html, -"pressure/uef"_compute_pressure_uef.html, -"property/atom"_compute_property_atom.html, -"property/chunk"_compute_property_chunk.html, -"property/local"_compute_property_local.html, -"ptm/atom"_compute_ptm_atom.html, -"rdf"_compute_rdf.html, -"reduce"_compute_reduce.html, -"reduce/chunk"_compute_reduce_chunk.html, -"reduce/region"_compute_reduce.html, -"rigid/local"_compute_rigid_local.html, -"saed"_compute_saed.html, -"slice"_compute_slice.html, -"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/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, -"snad/atom"_compute_sna_atom.html, -"snav/atom"_compute_sna_atom.html, -"spin"_compute_spin.html, -"stress/atom"_compute_stress_atom.html, -"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 (k)"_compute_temp.html, -"temp/asphere"_compute_temp_asphere.html, -"temp/body"_compute_temp_body.html, -"temp/chunk"_compute_temp_chunk.html, -"temp/com"_compute_temp_com.html, -"temp/cs"_compute_temp_cs.html, -"temp/deform"_compute_temp_deform.html, -"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, -"temp/profile"_compute_temp_profile.html, -"temp/ramp"_compute_temp_ramp.html, -"temp/region"_compute_temp_region.html, -"temp/region/eff"_compute_temp_region_eff.html, -"temp/rotate"_compute_temp_rotate.html, -"temp/sphere"_compute_temp_sphere.html, -"temp/uef"_compute_temp_uef.html, -"ti"_compute_ti.html, -"torque/chunk"_compute_torque_chunk.html, -"vacf"_compute_vacf.html, -"vcm/chunk"_compute_vcm_chunk.html, -"voronoi/atom"_compute_voronoi_atom.html, -"xrd"_compute_xrd.html :tb(c=6,ea=c) diff --git a/doc/txt/Commands_fix.txt b/doc/txt/Commands_fix.txt deleted file mode 100644 index cfd2bcf2ef..0000000000 --- a/doc/txt/Commands_fix.txt +++ /dev/null @@ -1,240 +0,0 @@ -"Higher level section"_Commands.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 - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -Fix commands :h3 - -An alphabetic list of all LAMMPS "fix"_fix.html commands. Some styles -have accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"adapt"_fix_adapt.html, -"adapt/fep"_fix_adapt_fep.html, -"addforce"_fix_addforce.html, -"addtorque"_fix_addtorque.html, -"append/atoms"_fix_append_atoms.html, -"atc"_fix_atc.html, -"atom/swap"_fix_atom_swap.html, -"ave/atom"_fix_ave_atom.html, -"ave/chunk"_fix_ave_chunk.html, -"ave/correlate"_fix_ave_correlate.html, -"ave/correlate/long"_fix_ave_correlate_long.html, -"ave/histo"_fix_ave_histo.html, -"ave/histo/weight"_fix_ave_histo.html, -"ave/time"_fix_ave_time.html, -"aveforce"_fix_aveforce.html, -"balance"_fix_balance.html, -"bocs"_fix_bocs.html, -"bond/break"_fix_bond_break.html, -"bond/create"_fix_bond_create.html, -"bond/react"_fix_bond_react.html, -"bond/swap"_fix_bond_swap.html, -"box/relax"_fix_box_relax.html, -"client/md"_fix_client_md.html, -"cmap"_fix_cmap.html, -"colvars"_fix_colvars.html, -"controller"_fix_controller.html, -"deform (k)"_fix_deform.html, -"deposit"_fix_deposit.html, -"dpd/energy (k)"_fix_dpd_energy.html, -"drag"_fix_drag.html, -"drude"_fix_drude.html, -"drude/transform/direct"_fix_drude_transform.html, -"drude/transform/inverse"_fix_drude_transform.html, -"dt/reset"_fix_dt_reset.html, -"edpd/source"_fix_dpd_source.html, -"efield"_fix_efield.html, -"ehex"_fix_ehex.html, -"electron/stopping"_fix_electron_stopping.html, -"enforce2d (k)"_fix_enforce2d.html, -"eos/cv"_fix_eos_cv.html, -"eos/table"_fix_eos_table.html, -"eos/table/rx (k)"_fix_eos_table_rx.html, -"evaporate"_fix_evaporate.html, -"external"_fix_external.html, -"ffl"_fix_ffl.html, -"filter/corotate"_fix_filter_corotate.html, -"flow/gauss"_fix_flow_gauss.html, -"freeze (k)"_fix_freeze.html, -"gcmc"_fix_gcmc.html, -"gld"_fix_gld.html, -"gle"_fix_gle.html, -"gravity (ko)"_fix_gravity.html, -"grem"_fix_grem.html, -"halt"_fix_halt.html, -"heat"_fix_heat.html, -"hyper/global"_fix_hyper_global.html, -"hyper/local"_fix_hyper_local.html, -"imd"_fix_imd.html, -"indent"_fix_indent.html, -"ipi"_fix_ipi.html, -"langevin (k)"_fix_langevin.html, -"langevin/drude"_fix_langevin_drude.html, -"langevin/eff"_fix_langevin_eff.html, -"langevin/spin"_fix_langevin_spin.html, -"latte"_fix_latte.html, -"lb/fluid"_fix_lb_fluid.html, -"lb/momentum"_fix_lb_momentum.html, -"lb/pc"_fix_lb_pc.html, -"lb/rigid/pc/sphere"_fix_lb_rigid_pc_sphere.html, -"lb/viscous"_fix_lb_viscous.html, -"lineforce"_fix_lineforce.html, -"manifoldforce"_fix_manifoldforce.html, -"meso"_fix_meso.html, -"meso/move"_fix_meso_move.html, -"meso/stationary"_fix_meso_stationary.html, -"momentum (k)"_fix_momentum.html, -"move"_fix_move.html, -"mscg"_fix_mscg.html, -"msst"_fix_msst.html, -"mvv/dpd"_fix_mvv_dpd.html, -"mvv/edpd"_fix_mvv_dpd.html, -"mvv/tdpd"_fix_mvv_dpd.html, -"neb"_fix_neb.html, -"neb_spin"_fix_neb_spin.html, -"nph (ko)"_fix_nh.html, -"nph/asphere (o)"_fix_nph_asphere.html, -"nph/body"_fix_nph_body.html, -"nph/eff"_fix_nh_eff.html, -"nph/sphere (o)"_fix_nph_sphere.html, -"nphug (o)"_fix_nphug.html, -"npt (iko)"_fix_nh.html, -"npt/asphere (o)"_fix_npt_asphere.html, -"npt/body"_fix_npt_body.html, -"npt/eff"_fix_nh_eff.html, -"npt/sphere (o)"_fix_npt_sphere.html, -"npt/uef"_fix_nh_uef.html, -"nve (iko)"_fix_nve.html, -"nve/asphere (i)"_fix_nve_asphere.html, -"nve/asphere/noforce"_fix_nve_asphere_noforce.html, -"nve/awpmd"_fix_nve_awpmd.html, -"nve/body"_fix_nve_body.html, -"nve/dot"_fix_nve_dot.html, -"nve/dotc/langevin"_fix_nve_dotc_langevin.html, -"nve/eff"_fix_nve_eff.html, -"nve/limit"_fix_nve_limit.html, -"nve/line"_fix_nve_line.html, -"nve/manifold/rattle"_fix_nve_manifold_rattle.html, -"nve/noforce"_fix_nve_noforce.html, -"nve/sphere (ko)"_fix_nve_sphere.html, -"nve/spin"_fix_nve_spin.html, -"nve/tri"_fix_nve_tri.html, -"nvk"_fix_nvk.html, -"nvt (iko)"_fix_nh.html, -"nvt/asphere (o)"_fix_nvt_asphere.html, -"nvt/body"_fix_nvt_body.html, -"nvt/eff"_fix_nh_eff.html, -"nvt/manifold/rattle"_fix_nvt_manifold_rattle.html, -"nvt/sllod (io)"_fix_nvt_sllod.html, -"nvt/sllod/eff"_fix_nvt_sllod_eff.html, -"nvt/sphere (o)"_fix_nvt_sphere.html, -"nvt/uef"_fix_nh_uef.html, -"oneway"_fix_oneway.html, -"orient/bcc"_fix_orient.html, -"orient/fcc"_fix_orient.html, -"phonon"_fix_phonon.html, -"pimd"_fix_pimd.html, -"planeforce"_fix_planeforce.html, -"plumed"_fix_plumed.html, -"poems"_fix_poems.html, -"pour"_fix_pour.html, -"precession/spin"_fix_precession_spin.html, -"press/berendsen"_fix_press_berendsen.html, -"print"_fix_print.html, -"property/atom (k)"_fix_property_atom.html, -"python/invoke"_fix_python_invoke.html, -"python/move"_fix_python_move.html, -"qbmsst"_fix_qbmsst.html, -"qeq/comb (o)"_fix_qeq_comb.html, -"qeq/dynamic"_fix_qeq.html, -"qeq/fire"_fix_qeq.html, -"qeq/point"_fix_qeq.html, -"qeq/reax (ko)"_fix_qeq_reax.html, -"qeq/shielded"_fix_qeq.html, -"qeq/slater"_fix_qeq.html, -"qmmm"_fix_qmmm.html, -"qtb"_fix_qtb.html, -"rattle"_fix_shake.html, -"reax/c/bonds (k)"_fix_reaxc_bonds.html, -"reax/c/species (k)"_fix_reaxc_species.html, -"recenter"_fix_recenter.html, -"restrain"_fix_restrain.html, -"rhok"_fix_rhok.html, -"rigid (o)"_fix_rigid.html, -"rigid/meso"_fix_rigid_meso.html, -"rigid/nph (o)"_fix_rigid.html, -"rigid/nph/small"_fix_rigid.html, -"rigid/npt (o)"_fix_rigid.html, -"rigid/npt/small"_fix_rigid.html, -"rigid/nve (o)"_fix_rigid.html, -"rigid/nve/small"_fix_rigid.html, -"rigid/nvt (o)"_fix_rigid.html, -"rigid/nvt/small"_fix_rigid.html, -"rigid/small (o)"_fix_rigid.html, -"rx (k)"_fix_rx.html, -"saed/vtk"_fix_saed_vtk.html, -"setforce (k)"_fix_setforce.html, -"shake"_fix_shake.html, -"shardlow (k)"_fix_shardlow.html, -"smd"_fix_smd.html, -"smd/adjust_dt"_fix_smd_adjust_dt.html, -"smd/integrate_tlsph"_fix_smd_integrate_tlsph.html, -"smd/integrate_ulsph"_fix_smd_integrate_ulsph.html, -"smd/move_tri_surf"_fix_smd_move_triangulated_surface.html, -"smd/setvel"_fix_smd_setvel.html, -"smd/wall_surface"_fix_smd_wall_surface.html, -"spring"_fix_spring.html, -"spring/chunk"_fix_spring_chunk.html, -"spring/rg"_fix_spring_rg.html, -"spring/self"_fix_spring_self.html, -"srd"_fix_srd.html, -"store/force"_fix_store_force.html, -"store/state"_fix_store_state.html, -"tdpd/source"_fix_dpd_source.html, -"temp/berendsen"_fix_temp_berendsen.html, -"temp/csld"_fix_temp_csvr.html, -"temp/csvr"_fix_temp_csvr.html, -"temp/rescale"_fix_temp_rescale.html, -"temp/rescale/eff"_fix_temp_rescale_eff.html, -"tfmc"_fix_tfmc.html, -"thermal/conductivity"_fix_thermal_conductivity.html, -"ti/spring"_fix_ti_spring.html, -"tmd"_fix_tmd.html, -"ttm"_fix_ttm.html, -"ttm/mod"_fix_ttm.html, -"tune/kspace"_fix_tune_kspace.html, -"vector"_fix_vector.html, -"viscosity"_fix_viscosity.html, -"viscous"_fix_viscous.html, -"wall/body/polygon"_fix_wall_body_polygon.html, -"wall/body/polyhedron"_fix_wall_body_polyhedron.html, -"wall/colloid"_fix_wall.html, -"wall/ees"_fix_wall_ees.html, -"wall/gran"_fix_wall_gran.html, -"wall/gran/region"_fix_wall_gran_region.html, -"wall/harmonic"_fix_wall.html, -"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, -"wall/region/ees"_fix_wall_ees.html, -"wall/srd"_fix_wall_srd.html :tb(c=6,ea=c) diff --git a/doc/txt/Commands_kspace.txt b/doc/txt/Commands_kspace.txt deleted file mode 100644 index 02b41b9d67..0000000000 --- a/doc/txt/Commands_kspace.txt +++ /dev/null @@ -1,37 +0,0 @@ -"Higher level section"_Commands.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.html) - -:line - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -KSpace solvers :h3 - -All LAMMPS "kspace_style"_kspace_style.html solvers. Some styles have -accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"ewald (o)"_kspace_style.html, -"ewald/disp"_kspace_style.html, -"msm (o)"_kspace_style.html, -"msm/cg (o)"_kspace_style.html, -"pppm (gok)"_kspace_style.html, -"pppm/cg (o)"_kspace_style.html, -"pppm/disp (i)"_kspace_style.html, -"pppm/disp/tip4p"_kspace_style.html, -"pppm/stagger"_kspace_style.html, -"pppm/tip4p (o)"_kspace_style.html, -"scafacos"_kspace_style.html :tb(c=4,ea=c) diff --git a/doc/txt/Commands_pair.txt b/doc/txt/Commands_pair.txt deleted file mode 100644 index e6ebd21987..0000000000 --- a/doc/txt/Commands_pair.txt +++ /dev/null @@ -1,253 +0,0 @@ -"Higher level section"_Commands.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 - -"General commands"_Commands_all.html, -"Fix styles"_Commands_fix.html, -"Compute styles"_Commands_compute.html, -"Pair styles"_Commands_pair.html, -"Bond styles"_Commands_bond.html, -"Angle styles"_Commands_bond.html#angle, -"Dihedral styles"_Commands_bond.html#dihedral, -"Improper styles"_Commands_bond.html#improper, -"KSpace styles"_Commands_kspace.html :tb(c=3,ea=c) - -Pair_style potentials :h3 - -All LAMMPS "pair_style"_pair_style.html commands. Some styles have -accelerated versions. This is indicated by additional letters in -parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = -OPT. - -"none"_pair_none.html, -"zero"_pair_zero.html, -"hybrid (k)"_pair_hybrid.html, -"hybrid/overlay (k)"_pair_hybrid.html, -, -, -, -, -"adp (o)"_pair_adp.html, -"agni (o)"_pair_agni.html, -"airebo (io)"_pair_airebo.html, -"airebo/morse (io)"_pair_airebo.html, -"atm"_pair_atm.html, -"awpmd/cut"_pair_awpmd.html, -"beck (go)"_pair_beck.html, -"body/nparticle"_pair_body_nparticle.html, -"body/rounded/polygon"_pair_body_rounded_polygon.html, -"body/rounded/polyhedron"_pair_body_rounded_polyhedron.html, -"bop"_pair_bop.html, -"born (go)"_pair_born.html, -"born/coul/dsf"_pair_born.html, -"born/coul/dsf/cs"_pair_cs.html, -"born/coul/long (go)"_pair_born.html, -"born/coul/long/cs (g)"_pair_cs.html, -"born/coul/msm (o)"_pair_born.html, -"born/coul/wolf (go)"_pair_born.html, -"born/coul/wolf/cs (g)"_pair_cs.html, -"brownian (o)"_pair_brownian.html, -"brownian/poly (o)"_pair_brownian.html, -"buck (giko)"_pair_buck.html, -"buck/coul/cut (giko)"_pair_buck.html, -"buck/coul/long (giko)"_pair_buck.html, -"buck/coul/long/cs"_pair_cs.html, -"buck/coul/msm (o)"_pair_buck.html, -"buck/long/coul/long (o)"_pair_buck_long.html, -"buck/mdf"_pair_mdf.html, -"buck6d/coul/gauss/dsf"_pair_buck6d_coul_gauss.html, -"buck6d/coul/gauss/long"_pair_buck6d_coul_gauss.html, -"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, -"coul/diel (o)"_pair_coul_diel.html, -"coul/dsf (gko)"_pair_coul.html, -"coul/long (gko)"_pair_coul.html, -"coul/long/cs (g)"_pair_cs.html, -"coul/long/soft (o)"_pair_fep_soft.html, -"coul/msm (o)"_pair_coul.html, -"coul/shield"_pair_coul_shield.html, -"coul/streitz"_pair_coul.html, -"coul/wolf (ko)"_pair_coul.html, -"coul/wolf/cs"_pair_cs.html, -"dpd (gio)"_pair_dpd.html, -"dpd/fdt"_pair_dpd_fdt.html, -"dpd/fdt/energy (k)"_pair_dpd_fdt.html, -"dpd/tstat (go)"_pair_dpd.html, -"dsmc"_pair_dsmc.html, -"e3b"_pair_e3b.html, -"drip"_pair_drip.html, -"eam (gikot)"_pair_eam.html, -"eam/alloy (gikot)"_pair_eam.html, -"eam/cd (o)"_pair_eam.html, -"eam/cd/old (o)"_pair_eam.html, -"eam/fs (gikot)"_pair_eam.html, -"edip (o)"_pair_edip.html, -"edip/multi"_pair_edip.html, -"edpd"_pair_meso.html, -"eff/cut"_pair_eff.html, -"eim (o)"_pair_eim.html, -"exp6/rx (k)"_pair_exp6_rx.html, -"extep"_pair_extep.html, -"gauss (go)"_pair_gauss.html, -"gauss/cut (o)"_pair_gauss.html, -"gayberne (gio)"_pair_gayberne.html, -"gran/hertz/history (o)"_pair_gran.html, -"gran/hooke (o)"_pair_gran.html, -"gran/hooke/history (ko)"_pair_gran.html, -"granular"_pair_granular.html, -"gw"_pair_gw.html, -"gw/zbl"_pair_gw.html, -"hbond/dreiding/lj (o)"_pair_hbond_dreiding.html, -"hbond/dreiding/morse (o)"_pair_hbond_dreiding.html, -"ilp/graphene/hbn"_pair_ilp_graphene_hbn.html, -"kim"_pair_kim.html, -"kolmogorov/crespi/full"_pair_kolmogorov_crespi_full.html, -"kolmogorov/crespi/z"_pair_kolmogorov_crespi_z.html, -"lcbop"_pair_lcbop.html, -"lebedeva/z"_pair_lebedeva_z.html, -"lennard/mdf"_pair_mdf.html, -"line/lj"_pair_line_lj.html, -"list"_pair_list.html, -"lj/charmm/coul/charmm (iko)"_pair_charmm.html, -"lj/charmm/coul/charmm/implicit (ko)"_pair_charmm.html, -"lj/charmm/coul/long (gikot)"_pair_charmm.html, -"lj/charmm/coul/long/soft (o)"_pair_fep_soft.html, -"lj/charmm/coul/msm (o)"_pair_charmm.html, -"lj/charmmfsw/coul/charmmfsh"_pair_charmm.html, -"lj/charmmfsw/coul/long"_pair_charmm.html, -"lj/class2 (gko)"_pair_class2.html, -"lj/class2/coul/cut (ko)"_pair_class2.html, -"lj/class2/coul/cut/soft"_pair_fep_soft.html, -"lj/class2/coul/long (gko)"_pair_class2.html, -"lj/class2/coul/long/soft"_pair_fep_soft.html, -"lj/class2/soft"_pair_fep_soft.html, -"lj/cubic (go)"_pair_lj_cubic.html, -"lj/cut (gikot)"_pair_lj.html, -"lj/cut/coul/cut (gko)"_pair_lj.html, -"lj/cut/coul/cut/soft (o)"_pair_fep_soft.html, -"lj/cut/coul/debye (gko)"_pair_lj.html, -"lj/cut/coul/dsf (gko)"_pair_lj.html, -"lj/cut/coul/long (gikot)"_pair_lj.html, -"lj/cut/coul/long/cs"_pair_cs.html, -"lj/cut/coul/long/soft (o)"_pair_fep_soft.html, -"lj/cut/coul/msm (go)"_pair_lj.html, -"lj/cut/coul/wolf (o)"_pair_lj.html, -"lj/cut/dipole/cut (go)"_pair_dipole.html, -"lj/cut/dipole/long (g)"_pair_dipole.html, -"lj/cut/dipole/sf (go)"_pair_dipole.html, -"lj/cut/soft (o)"_pair_fep_soft.html, -"lj/cut/thole/long (o)"_pair_thole.html, -"lj/cut/tip4p/cut (o)"_pair_lj.html, -"lj/cut/tip4p/long (ot)"_pair_lj.html, -"lj/cut/tip4p/long/soft (o)"_pair_fep_soft.html, -"lj/expand (gko)"_pair_lj_expand.html, -"lj/expand/coul/long (g)"_pair_lj_expand.html, -"lj/gromacs (gko)"_pair_gromacs.html, -"lj/gromacs/coul/gromacs (ko)"_pair_gromacs.html, -"lj/long/coul/long (iot)"_pair_lj_long.html, -"lj/long/dipole/long"_pair_dipole.html, -"lj/long/tip4p/long (o)"_pair_lj_long.html, -"lj/mdf"_pair_mdf.html, -"lj/sdk (gko)"_pair_sdk.html, -"lj/sdk/coul/long (go)"_pair_sdk.html, -"lj/sdk/coul/msm (o)"_pair_sdk.html, -"lj/sf/dipole/sf (go)"_pair_dipole.html, -"lj/smooth (o)"_pair_lj_smooth.html, -"lj/smooth/linear (o)"_pair_lj_smooth_linear.html, -"lj/switch3/coulgauss/long"_pair_lj_switch3_coulgauss.html, -"lj96/cut (go)"_pair_lj96.html, -"local/density"_pair_local_density.html, -"lubricate (o)"_pair_lubricate.html, -"lubricate/poly (o)"_pair_lubricate.html, -"lubricateU"_pair_lubricateU.html, -"lubricateU/poly"_pair_lubricateU.html, -"mdpd"_pair_meso.html, -"mdpd/rhosum"_pair_meso.html, -"meam/c"_pair_meamc.html, -"meam/spline (o)"_pair_meam_spline.html, -"meam/sw/spline"_pair_meam_sw_spline.html, -"mgpt"_pair_mgpt.html, -"mie/cut (g)"_pair_mie.html, -"momb"_pair_momb.html, -"morse (gkot)"_pair_morse.html, -"morse/smooth/linear (o)"_pair_morse.html, -"morse/soft"_pair_fep_soft.html, -"multi/lucy"_pair_multi_lucy.html, -"multi/lucy/rx (k)"_pair_multi_lucy_rx.html, -"nb3b/harmonic"_pair_nb3b_harmonic.html, -"nm/cut (o)"_pair_nm.html, -"nm/cut/coul/cut (o)"_pair_nm.html, -"nm/cut/coul/long (o)"_pair_nm.html, -"oxdna/coaxstk"_pair_oxdna.html, -"oxdna/excv"_pair_oxdna.html, -"oxdna/hbond"_pair_oxdna.html, -"oxdna/stk"_pair_oxdna.html, -"oxdna/xstk"_pair_oxdna.html, -"oxdna2/coaxstk"_pair_oxdna2.html, -"oxdna2/dh"_pair_oxdna2.html, -"oxdna2/excv"_pair_oxdna2.html, -"oxdna2/hbond"_pair_oxdna2.html, -"oxdna2/stk"_pair_oxdna2.html, -"oxdna2/xstk"_pair_oxdna2.html, -"peri/eps"_pair_peri.html, -"peri/lps (o)"_pair_peri.html, -"peri/pmb (o)"_pair_peri.html, -"peri/ves"_pair_peri.html, -"polymorphic"_pair_polymorphic.html, -"python"_pair_python.html, -"quip"_pair_quip.html, -"reax/c (ko)"_pair_reaxc.html, -"rebo (io)"_pair_airebo.html, -"resquared (go)"_pair_resquared.html, -"sdpd/taitwater/isothermal"_pair_sdpd_taitwater_isothermal.html, -"smd/hertz"_pair_smd_hertz.html, -"smd/tlsph"_pair_smd_tlsph.html, -"smd/tri_surface"_pair_smd_triangulated_surface.html, -"smd/ulsph"_pair_smd_ulsph.html, -"smtbq"_pair_smtbq.html, -"snap (k)"_pair_snap.html, -"snap (k)"_pair_snap.html, -"soft (go)"_pair_soft.html, -"sph/heatconduction"_pair_sph_heatconduction.html, -"sph/idealgas"_pair_sph_idealgas.html, -"sph/lj"_pair_sph_lj.html, -"sph/rhosum"_pair_sph_rhosum.html, -"sph/taitwater"_pair_sph_taitwater.html, -"sph/taitwater/morris"_pair_sph_taitwater_morris.html, -"spin/dipole/cut"_pair_spin_dipole.html, -"spin/dipole/long"_pair_spin_dipole.html, -"spin/dmi"_pair_spin_dmi.html, -"spin/exchange"_pair_spin_exchange.html, -"spin/magelec"_pair_spin_magelec.html, -"spin/neel"_pair_spin_neel.html, -"srp"_pair_srp.html, -"sw (giko)"_pair_sw.html, -"table (gko)"_pair_table.html, -"table/rx (k)"_pair_table_rx.html, -"tdpd"_pair_meso.html, -"tersoff (giko)"_pair_tersoff.html, -"tersoff/mod (gko)"_pair_tersoff_mod.html, -"tersoff/mod/c (o)"_pair_tersoff_mod.html, -"tersoff/table (o)"_pair_tersoff.html, -"tersoff/zbl (gko)"_pair_tersoff_zbl.html, -"thole"_pair_thole.html, -"tip4p/cut (o)"_pair_coul.html, -"tip4p/long (o)"_pair_coul.html, -"tip4p/long/soft (o)"_pair_fep_soft.html, -"tri/lj"_pair_tri_lj.html, -"ufm (got)"_pair_ufm.html, -"vashishta (gko)"_pair_vashishta.html, -"vashishta/table (o)"_pair_vashishta.html, -"yukawa (gko)"_pair_yukawa.html, -"yukawa/colloid (go)"_pair_yukawa_colloid.html, -"zbl (gko)"_pair_zbl.html :tb(c=4,ea=c) diff --git a/doc/txt/Commands_removed.txt b/doc/txt/Commands_removed.txt deleted file mode 100644 index 1eee6e45e0..0000000000 --- a/doc/txt/Commands_removed.txt +++ /dev/null @@ -1,66 +0,0 @@ -"Higher level section"_Commands.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.html) - -:line - -Removed commands and packages :h3 - -This page lists LAMMPS commands and packages that have been removed from -the distribution and provides suggestions for alternatives or replacements. -LAMMPS has special dummy styles implemented, that will stop LAMMPS and -print a suitable error message in most cases, when a style/command is used -that has been removed. - -Fix ave/spatial and fix ave/spatial/sphere :h4 - -The fixes ave/spatial and ave/spatial/sphere have been removed from LAMMPS -since they were superseded by the more general and extensible "chunk -infrastructure". Here the system is partitioned in one of many possible -ways through the "compute chunk/atom"_compute_chunk_atom.html command -and then averaging is done using "fix ave/chunk"_fix_ave_chunk.html. -Please refer to the "chunk HOWTO"_Howto_chunk.html section for an overview. - -MEAM package :h4 - -The MEAM package has been removed since it was superseded by the -"USER-MEAMC package"_Package_details.html#PKG-USER-MEAMC. The code in -the USER-MEAMC package is a translation of the Fortran code of MEAM into C++, -which removes several restrictions (e.g. there can be multiple instances -in hybrid pair styles) and allows for some optimizations leading -to better performance. The new pair style "meam/c"_pair_meamc.html has -the exact same syntax as the old "meam" pair style and thus pair style -"meam"_pair_meamc.html is an alias to the new style and backward -compatibility of old inputs is preserved. - -REAX package :h4 - -The REAX package has been removed since it was superseded by the -"USER-REAXC package"_Package_details.html#PKG-USER-REAXC. The USER-REAXC -package has been tested to yield equivalent results to the REAX package, -offers better performance, supports OpenMP multi-threading via USER-OMP, -and GPU and threading parallelization through KOKKOS. The new pair styles -are not syntax compatible with the removed reax pair style, so input -files will have to be adapted. - -USER-CUDA package :h4 - -The USER-CUDA package had been removed, since it had been unmaintained -for a long time and had known bugs and problems. Significant parts of -the design were transferred to the -"KOKKOS package"_Package_details.html#PKG-KOKKOS, which has similar -performance characteristics on Nvidia GPUs. Both, the KOKKOS -and the "GPU package"_Package_details.html#PKG-GPU are maintained -and allow running LAMMPS with GPU acceleration. - -restart2data tool :h4 - -The functionality of the restart2data tool has been folded into the -LAMMPS executable directly instead of having a separate tool. A -combination of the commands "read_restart"_read_restart.html and -"write_data"_write_data.html can be used to the same effect. For added -convenience this conversion can also be triggered by "command line -flags"_Run_options.html diff --git a/doc/txt/Commands_structure.txt b/doc/txt/Commands_structure.txt deleted file mode 100644 index b5d2c7b07b..0000000000 --- a/doc/txt/Commands_structure.txt +++ /dev/null @@ -1,95 +0,0 @@ -"Higher level section"_Commands.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 - -Input script structure :h3 - -This page describes the structure of a typical LAMMPS input script. -The examples directory in the LAMMPS distribution contains many sample -input scripts; it is discussed on the "Examples"_Examples.html doc -page. - -A LAMMPS input script typically has 4 parts: - -Initialization -Atom definition -Settings -Run a simulation :ol - -The last 2 parts can be repeated as many times as desired. I.e. run a -simulation, change some settings, run some more, etc. Each of the 4 -parts is now described in more detail. Remember that almost all -commands need only be used if a non-default value is desired. - -(1) Initialization - -Set parameters that need to be defined before atoms are created or -read-in from a file. - -The relevant commands are "units"_units.html, -"dimension"_dimension.html, "newton"_newton.html, -"processors"_processors.html, "boundary"_boundary.html, -"atom_style"_atom_style.html, "atom_modify"_atom_modify.html. - -If force-field parameters appear in the files that will be read, these -commands tell LAMMPS what kinds of force fields are being used: -"pair_style"_pair_style.html, "bond_style"_bond_style.html, -"angle_style"_angle_style.html, "dihedral_style"_dihedral_style.html, -"improper_style"_improper_style.html. - -(2) Atom definition - -There are 3 ways to define atoms in LAMMPS. Read them in from a data -or restart file via the "read_data"_read_data.html or -"read_restart"_read_restart.html commands. These files can contain -molecular topology information. Or create atoms on a lattice (with no -molecular topology), using these commands: "lattice"_lattice.html, -"region"_region.html, "create_box"_create_box.html, -"create_atoms"_create_atoms.html. The entire set of atoms can be -duplicated to make a larger simulation using the -"replicate"_replicate.html command. - -(3) Settings - -Once atoms and molecular topology are defined, a variety of settings -can be specified: force field coefficients, simulation parameters, -output options, etc. - -Force field coefficients are set by these commands (they can also be -set in the read-in files): "pair_coeff"_pair_coeff.html, -"bond_coeff"_bond_coeff.html, "angle_coeff"_angle_coeff.html, -"dihedral_coeff"_dihedral_coeff.html, -"improper_coeff"_improper_coeff.html, -"kspace_style"_kspace_style.html, "dielectric"_dielectric.html, -"special_bonds"_special_bonds.html. - -Various simulation parameters are set by these commands: -"neighbor"_neighbor.html, "neigh_modify"_neigh_modify.html, -"group"_group.html, "timestep"_timestep.html, -"reset_timestep"_reset_timestep.html, "run_style"_run_style.html, -"min_style"_min_style.html, "min_modify"_min_modify.html. - -Fixes impose a variety of boundary conditions, time integration, and -diagnostic options. The "fix"_fix.html command comes in many flavors. - -Various computations can be specified for execution during a -simulation using the "compute"_compute.html, -"compute_modify"_compute_modify.html, and "variable"_variable.html -commands. - -Output options are set by the "thermo"_thermo.html, "dump"_dump.html, -and "restart"_restart.html commands. - -(4) Run a simulation - -A molecular dynamics simulation is run using the "run"_run.html -command. Energy minimization (molecular statics) is performed using -the "minimize"_minimize.html command. A parallel tempering -(replica-exchange) simulation can be run using the -"temper"_temper.html command. - From 7d289063b414e11a7c1b50de77d41351d95c0b8e Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sun, 24 Nov 2019 19:23:16 -0700 Subject: [PATCH 502/557] Update src/Command*.rst files --- doc/src/Commands.rst | 8 +- doc/src/Commands_all.rst | 180 +++++++++++----- doc/src/Commands_angle.rst | 55 +++++ doc/src/Commands_bond.rst | 140 ++++--------- doc/src/Commands_category.rst | 5 - doc/src/Commands_compute.rst | 218 +++++++++++++------ doc/src/Commands_dihedral.rst | 51 +++++ doc/src/Commands_fix.rst | 314 ++++++++++++++++++++-------- doc/src/Commands_improper.rst | 46 +++++ doc/src/Commands_input.rst | 5 - doc/src/Commands_kspace.rst | 44 ++-- doc/src/Commands_pair.rst | 368 ++++++++++++++++++++++----------- doc/src/Commands_parse.rst | 5 - doc/src/Commands_structure.rst | 5 - 14 files changed, 978 insertions(+), 466 deletions(-) create mode 100644 doc/src/Commands_angle.rst create mode 100644 doc/src/Commands_dihedral.rst create mode 100644 doc/src/Commands_improper.rst diff --git a/doc/src/Commands.rst b/doc/src/Commands.rst index e845faa903..79fa30003d 100644 --- a/doc/src/Commands.rst +++ b/doc/src/Commands.rst @@ -21,14 +21,12 @@ commands in it are used to define a LAMMPS simulation. Commands_compute Commands_pair Commands_bond + Commands_angle + Commands_dihedral + Commands_improper Commands_kspace .. toctree:: :maxdepth: 1 Commands_removed - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/src/Commands_all.rst b/doc/src/Commands_all.rst index 583e9e3c3a..b9f5578137 100644 --- a/doc/src/Commands_all.rst +++ b/doc/src/Commands_all.rst @@ -1,59 +1,135 @@ -+----------------------------------------+------------------------------------+------------------------------------------+ -| :doc:`General commands ` | :doc:`Fix styles ` | :doc:`Compute styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ -| :doc:`Pair styles ` | :doc:`Bond styles ` | :ref:`Angle styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ -| :ref:`Dihedral styles ` | :ref:`Improper styles ` | :doc:`KSpace styles ` | -+----------------------------------------+------------------------------------+------------------------------------------+ +.. table_from_list:: + :columns: 3 + + * :doc:`General commands ` + * :doc:`Fix styles ` + * :doc:`Compute styles ` + * :doc:`Pair styles ` + * :doc:`Bond styles ` + * :doc:`Angle styles ` + * :doc:`Dihedral styles ` + * :doc:`Improper styles ` + * :doc:`KSpace styles ` General commands ================ An alphabetic list of all general LAMMPS commands. -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`angle\_coeff ` | :doc:`angle\_style ` | :doc:`atom\_modify ` | :doc:`atom\_style ` | :doc:`balance ` | :doc:`bond\_coeff ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`bond\_style ` | :doc:`bond\_write ` | :doc:`boundary ` | :doc:`box ` | :doc:`change\_box ` | :doc:`clear ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`comm\_modify ` | :doc:`comm\_style ` | :doc:`compute ` | :doc:`compute\_modify ` | :doc:`create\_atoms ` | :doc:`create\_bonds ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`create\_box ` | :doc:`delete\_atoms ` | :doc:`delete\_bonds ` | :doc:`dielectric ` | :doc:`dihedral\_coeff ` | :doc:`dihedral\_style ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`dimension ` | :doc:`displace\_atoms ` | :doc:`dump ` | :doc:`dump adios ` | :doc:`dump image ` | :doc:`dump movie ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`dump netcdf ` | :doc:`dump netcdf/mpiio ` | :doc:`dump vtk ` | :doc:`dump\_modify ` | :doc:`dynamical\_matrix ` | :doc:`echo ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`fix ` | :doc:`fix\_modify ` | :doc:`group ` | :doc:`group2ndx ` | :doc:`hyper ` | :doc:`if ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`info ` | :doc:`improper\_coeff ` | :doc:`improper\_style ` | :doc:`include ` | :doc:`jump ` | :doc:`kim\_init ` | -+-----------------------------------------+-----------------------------------------+-----------------------------------------+-----------------------------------------+---------------------------------------------+-----------------------------------------+ -| :doc:`kim\_interactions ` | :doc:`kim\_query ` | :doc:`kspace\_modify ` | :doc:`kspace\_style ` | :doc:`label

    E)%&O8WfF-VnU&^gV0_|b5E>SFM-E9HLEPqtkhpiL_?`web zE0>xD-hQn>f^N0y0Kr>6@ms*Z#1L5Q1y;78GfvN!VcWF8?boGT``ov3r+r^S3-&szv}|L2*WGxkHe%D1XO7XueRNhV=*wG>nGn91e%C7X-(ye=5Cj{wzNS9+DiI37hKMH}ZSfAy&7QMrGkzg{zDe5`6sl?Mtc%>*C7wB z2Jfy`p7y$gl|F(?6(YK&$g%0NWkM_mtx6JKy(#$rx@GXx*hg6INvd5kJNMFJMkc1a z73w7}LKdYI;$506ta*_Ag?}sxqV`tI?eU&q4J;fn`%(fpv-2;G@6ga-@jR&ZBM9V! zf1_WnX7KBc|I{=EjM`7%6tlGqI6r$!OYv`pfR0w}-BVx`wP2NBbKsfzh3eaE?sv8E z2!eE?i7JWE^|~fR{d?InASG4mvn)Hqq}1tJ?n6wGxp-k0H+-`LRlz+J@^&7&qC^~s zY=JCa01LKv$Ar%)?0X;?$LA1BiZ?>msV;uCGMC{iVxubN#Y&tZI>C*D>kK^$)7S)` zGZ~tAQvRY)Zq;JA1!EA>Nq_0Pxyj2hg-SiqjJDuTb&O~KW>X!s{IH)bn zBt%RkLCHH0@S^E-9Xr!TV>`{7FsFAY3oPuBeq7D-5jorS#Aycy8{R>_RRC!@#ho70 zz9sX&^FJO^Sx=N2w?%OW1y5}`U+u+rJ|?L{)(ttkragW7j=kg{($}kF$E~>jvjMfg z2u-qy`t<2V?u4|;s@EM1QGQeApkKnu>BFis94Mm5e zuUZD-ch9+F)n;v9QmnpDbh^NeLC3^VV6DqA^6fW^#)e|kg|MgR{M^kL%mcm#wq*f+(UA9OGGa(S(ziKVe{&|(;WL!Saj zgW7EX?3{U-C^-n|!Hwc3;xl*b<05+K@y3jKypqv}mRaAW=W_BrAERo*t^&$9faR$= zn~X0bUhN64GF>SKgmYO4*iTnUJk{D*6-CyRxXMj>C0~v>@(n+jaJM!8TfnPS=N29)?VU#>Wf_%hSG5py57ru?_wRO7gj}l7Am%M@v!yTLV>nzr#3aY@?;(fcz5rQ$SZ|Gxd*scM=-z|@o#QFm)j@VCE z{yBIpV`&rzX?TK0(Z&;&$4N(`v&609zkuDY3OPnizU;=VFzTGo>>eAi6iE4%y=D|P zO{$kQG-D5pCRq%{>W$toZCyqa9$5W|c12imTtsGDA+F#0&{QD4Ls#y+y2T6FFQj2T z$u9I)rtUC09_-0{RK@JatX}p$P3Lt<8qg!CeZtNJjjg*-bD$e5b(oTYFrr*=kMxLQ zJw~71@>|Wd_R=)ht8dXT32<`H*0?-pVY%(5CZ;AQ%Yv?Gi;(R25Q-NNyO4dstIe0b zG^TEXoeOm8zzn9;Pj}m z$34)eFq=n0FaiESro$3HD@wYgdCh7oJ+@C%klKDoRi1!W#Y+W8zejxvch|CN^ky;< zGn^LFqX&mGktAn7fvpYF*8o-HYrxCWtE1^S>jWLQ2M(@O@67yy;Dbn#Pzv-5SH3d= z;x46so>RUHI`ygrSyt<3Ji0sq?kUTRS+~-ZUSMu!8$9UQHGZV>b zQ^a>YzQ~{V??CMs9h9t32|95vq)iM*iC8%lZMQ;)HxVr$uY~8|P5e}L>Xe7nGFcHf zqBYau)zbw6zx=H}*&pw-t?EnYEcDNrqSLWjr?WJg4AkG=qFsRmYO^B+o0B`El*A{U zc{$0kD|x+3g|xQg)6UQrUBk7;0UYh{O{le8XxncCS=Sqy=&tZurV)GBkQ%~l@SAc5 zyr}kv)ccszJFqk^Eiei$e(70vF7%PG zwXO%8eFG`tkA35Kj(;b%D(2r2%3)gsxlogB;bCmaeU_EtmSX7a!9R*c>W_q+hV0dX zNUYcW{~`sqW2OEnYHq1fv02tY6eQeIS3Lp>II}v%o|sNmv`Vrp&mqnZD)qGK|D5Rp zd0!jl$vbIh-|00s++Q{@KK|k1WDT#RsBb;2D=&VJx1suRTQzaJoG;CEq+`kEO&JiI zxtePbc?}SOkz4~Pa3)TU{j$Q`S^HQesT|pGd;W7e^ly|z2KTSc?=|zlDt4Cn`2`M$ zyo*rPK6f8kNt01#Jz9k=Uo`pMq{r`LiDYi=3!Ok066@|-orYt)l1lK32Ww!W)qcHi zT*A|--DwyoJwe^Zy@!>9zP#tx$x+4V(Eg+Fz_N*JfN$oC0y5eyLVI4acdwyJUt&=7 zWVvF~%ef9&fvWSBTWE>S(wCk(5KXKLU(Zqf-Yu4y?&fe={MOXOuK&*Xr*k@Sx94LO zo5;bMHT_1N(9jh3Tj%3`oHWImf`N11TQwb*g8nvZO5dCw*&A*8>$cXX)m5JWl&tkk z6ejc-KXt!I>0d2cv3X3CHQq2o{R$f-pSuj0;_y*gwi{dlO&kmC#hYR^7hnV`_{eqpGcMCh&R7S zk-EOV>QA%eHmIRc=>V3B+OIFspjxLOjGWY&?h8pPN}jr&cRxkXr0Fl4xl?^+a&Pm9 z10cey)9o#MC%PwGJ7rB@HU!c+d6B#)Ul*5_l+n7}VYKaX9FaqX_}xO3jj0_kH3y$+ zmlTz4wQ3qJqdy9ShtNjK{+(AoDyweH8+%{J@m=#L{P{rf9jOOq5t7Eci8wiX!{N&$ z4FD0Yw3zwgML*&DJW*SIsZbrJ;jX8{L~LE7T?(pP9O_Ck3&nXf&%NteJ2SA>qLHny zl6_`d9Gi-U3jByF#Z^#KM-8!mi9zO9y?5=3?yT@8kfGB1&+;Oj6 z?3R#lAPhz%AMk6u#j|N`w#X3<#n>J%e-uI|j_8n{Wnq)}sy7GRHIGMuA;8L|O9ziC zg62}*c1`Pi*$d7AT3b@kZ|Hy}#GZA+Vq>R-Tp_Q?M{=v4-;u(2sNw;w^FgfoH=p&u zG7X$cRm)#^EoMzi>o<5rP~Z;k)9mAg~ltjq*|QDlWhjDw+Kkhc+Y5^ z{(xBpuJmX~t$8$_@XiPiACutq6s(?vzmD~)NVlIW7QVP&{va`KWMnKNbd|0M&bB}? zUY2jRA{U|(*GCStYVrOSc7E=>M5LU#(7?Zv(PzH*?@C%UsW9#rn04DQr$W5`f)+z3 zRTbbfSpSqzT!`=J_r}JS_gE%bi}T$A{a)U!mhF^p!@0k&I&guAl*_~!cOEdlhk|E`Sx08X?3Xu*mWLx_d??Oodog}2sTL{H;yg8liex57$)5W>e z&a-oH1uLKZczWOrBez74FU#u#imp_OwQ{CuWcO$DsCC4&3}fhaNg4*6h6dW;?M=(F zUiAIOj$kNXJ4{H1k&=HQ+JKTBQ&YyLq5;GGi9-!|_PRtfoY0Nb$q=$e4qW8`K%NAO z#-1}ZrA{`BO%olS?${rye2M-+lw1tdj`7+6C{q8{0oDkEM0uuM17x-wsdeN+L&yG_ ziB3U6Pq))6k4XgnMIvhu)HvHTy#$Z8_09bHybs&0khK0&y9ptf4J=PwQEj^5R@^Q9 zT|svilWPFmHy@n*$=T+c#^m$An_m0KyhCJk?>~Wflnc9RLQKGSBje1^1qHR8%gV>^ zt^rkDYOgn-WZ{aolPvCRG(Ji9o2~)t%jJ>L1rv?2%_D=hug-~$$R@Ce<2;pfIYL}K z-q=^g^^84fkMIe3B=n(3YbPhCk(~Y-&{+L-&2!xDEe7e?DftVH7#)xpqJ}xx%w%IA z0KhGt3;y{3Muf*^zENX@d2O%>YxaI@>RB({cu`u2Eo_+QxT1__gBT9{@Gb{NU?MnA zyBA6ED95lxb&SPZ9K#&&IsW7mzawM#Hr->DZD`9!Y_EEHBWhX5gFI5fs6g>elGXux z%Bq{Ui`b$My#|n$UIPRLe*9mJ0bf}YFV=3E3236#eUX*@@jR=Jwkc|xso}F^EJc69 zFE+{bblL1wXK3zn0!o3rZ|~zbhH@1UN!`EHD)O4PhMbO3&Tq#j5L&}KT)#f*I;qL% zzK*}!ZqRFq8_m649_MWy*HmU^58+JQkt5yRi-15LeSE(O^C_br0|W2I7s5j{Dl$$N zQz{3Q$C8}pdKO>g95<|?W-!G#7926*`;>-T17u+h%#%pUc;7 z?flpf4!T>_*iT`qO1*zZh(6!6X6rLQP(aJ)mQ6Zai{l4qzuET|(lgUICTQ38T-4y? z4?W&(f*3T8Lp$(g#^h9S%QB_glNsXGyOtP+Ulq0dow$={tfmiKUA>$)$>Te4UNyK2 zwf&Z71C8>|w}Of}YV7PP4SsAgO~HaIEAUT&Ue=xwC)FNmgd%o>KKB})E{pxs?(yc_ zzjbVg)7lfJjLAHSW0<{hsbpen&1cdC>3nqtC3#at-FY=|%M;dd(h>^R>C!f~y5zX2wq~|=F0Vf?EP3W2XoOYks zw4*t0@{4tnguf1Zmq{Y%om{arH(1~yG}=sXwerMPhfEKpAPP0n6RC+$=sC_I_BvIK zk56xm+hnKULp6#7V*!+N;vwt9GPJ& zPrE_Hxg-MV#ec?Q(T~5ylOo22malI@`eWKy7Lxp&2~M=m`!b&!J|7yhWsNF7)Dn@< z%?M{&34MWcfyBxV`OF8?9Gp7Z#0(`>NIn;v3<-ANE%n;K(vR^Y&C#8r%Px`MUSF)WX1ok5S(iXK(1W@?Pm~KU`DxZ{wE;4EPtN zYl=7ajWks>tld^?OhQTn;};0vEU2ldZUT= zjLT>ex9Hh5V7Bs^|C-wx5ZLzuW#L%z1=WvrCq>w#1!`qPxN-oDXI683OlVX0TQ?$J z)bBELe%11nW4bRSPn#m)8+YZ5QywsQ1%mP2>l16WX>u0r*&`s}QYC=)!{D;snqy3N*VLM>P_!R^6Uy~RA&_`(4d`viO$8}!Pb6|$IwkX1|Vv|7+ z?&z_ySKTl;gVae}(ma?vE0-ED>US;s(jxM=D31G&`|M3Bcd+;>W=;c>9WFjcQdkrjb+LC1 z2#Xr>fi%7s6S;Em8Wxx?JR+8b^vQXzt6`*+pyIiYCv7f@IivzYVZiw(_598T_21*H z+Z@e`A|bYE0!ASZ=VtB>g;+i3@);R3otoB;L)I0P3gfMOq;$*wtjLTLgc>O9cUEI* zqs#w=qqt+s*mp?wk`(IUTXR0&8CVNGib_0M*xlJ8 z>Z%g)9X8aAKIFN{qrl}Otl^BLzgVEFd(D-#|MQW1%0EFpR|aD!F=^Qfylgg}yaPIC zKvZ?e$`OFS_s6@+JBzu*=Sx!1fKhY#&K=o^hB8`PvTt-Z^_dcjpK$WSxi?Ewf{&;M zOxn%v*Aik8{S`mj(&}IVkx6Zy(-^khs>$sS#bta%eu$4i#onT&l7-@)q7jG0E}kd8 zNfQ>6EC)P6ir>qfVvN*Xyy`iM$7S!QRq<39p%Xi-xb~J8@_D@Hn~y45Gf&=X|1Wk? zf*-UygrQ9#-1#7ZkeOcQoPCV%KdY8DtDjANc2y94lV+Qwu*L6KnT;N3d!*w zWQ7=Bt$Hh1S$%Vh$|O6Ftzb1FB3ddZrLY}jJsDAcXL?n1Zg9ooGIYqlfPG_R5w&mf zXdg0?D;d@f*KzLjpHt(%DtEf@L$b)%%oIT3hrV;|*xk{G?v{>Y9*Wv6ii-4yetVs$|1 zwVD!s>m!}fp}n#2z%RPj0P|hdAI4H&e4Dov6_?*RPNY_;D9G6TCyUrAw-1#<6BCj8 zkP4Xho*RxSn>M!k7r5SXIqV4DGiG~&2^6tJ;|<#duL0Pl^G}P{fIk9(eN>O%Ugbl% z&#ZO8J+temp7om)nFjI^Mm{v`5PZ?2NA_-OfnH&ykhzS%_iKpe9(m`Pp)r%65xS}# z$oqW&aP|ImMr_*am9Lg9^6o5tUIK*`RFh-nR_D&HUU@&Axew&5q@R%<@=La{U{nuPv~;PqmNO3HTf91Cz^fG->w|q?DLEc zwEVgBAX7$_I0rhCuP0uzIG%&|MB^KKQb~lYu5u%f9hE_@*uBO-&0b34kd{${M4z}HEi*j z6tK}eH|Q57>^>W4JLoFRbCIMo;FkzuOn($tklr=b4cms=45^*TZOel5#{iunkO%7p0talR06W8zL9{nU`39?EBd3?ea} z_nNM@OVSY1x6GnY;hsb*@yXn2ho&Vdu=#l#)J&4ui#>vK!3(AvSTx0~?% zzVzGtjpF1xpn8FbMIhp&YGQ4ON^OP#@Q}-!(93Xt&`nZKkWZ;6A0K>K)xD#>l0PNA zFWH(Ym|1Y(wO)M$-7-~7j)3k9bs{-Qbsy@b$*k^V*$QcM!dwuxLpC!#Jl;EynhJs7 zKD@lq*Q-YY-B;wXl3#P1kM-|B1?G*|7^;Eps)ia9tqd)XKU0rFsddr}Siugq?(-}8 z!wN|{J%U5n72{)>fHxUhC{Y4Z+F6p-WKOnbe(~?hiLYq)(v@W)*U;4<NW*Tl zVTAF5U&^uv!bp5e6&Q-2Syhh=k(L1C)MvryYD5IF0v$A`y+zZ4GxDX5TONqAkJ43Xx*f!3zaats1T3^r&Tv7DwfmkIO%*GA0duBq{W+ z-bS!y;$LsHcZ$n5rOA6R@C)9*$|7T^H@Fpxfzl*3#qcfS>4CzaG=h}me~VI^5FGtx{lZ_t+03g=#Frd$_6F7F?V z1-bxo#5_eiZ9Ddf%3Yg7i^AH&>hcdSZXtM22j$h` or :doc:`read\_restart ` commands: -* K (energy/distance\^4) -* B1 (distance) -* B2 (distance) -* Rc (distance) -* U0 (energy) +* :math:`K` (energy/distance\^4) +* :math:`B_1` (distance) +* :math:`B_2` (distance) +* :math:`R_c` (distance) +* :math:`U_0` (energy) This potential was constructed to mimic the FENE bond potential for -coarse-grained polymer chains. When monomers with sigma = epsilon = -1.0 are used, the following choice of parameters gives a quartic -potential that looks nearly like the FENE potential: K = 1200, B1 = --0.55, B2 = 0.25, Rc = 1.3, and U0 = 34.6878. Different parameters -can be specified using the :doc:`bond\_coeff ` command, but -you will need to choose them carefully so they form a suitable bond -potential. +coarse-grained polymer chains. When monomers with :math:`\sigma = \epsilon = 1.0` +are used, the following choice of parameters gives a quartic potential that +looks nearly like the FENE potential: -Rc is the cutoff length at which the bond potential goes smoothly to a -local maximum. If a bond length ever becomes > Rc, LAMMPS "breaks" +.. math:: + + K &= 1200 \\ + B_1 &= -0.55 \\ + B_2 &= 0.25 \\ + R_c &= 1.3 \\ + U_0 &= 34.6878 + +Different parameters can be specified using the :doc:`bond_coeff ` +command, but you will need to choose them carefully so they form a suitable +bond potential. + +:math:`R_c` is the cutoff length at which the bond potential goes smoothly to a +local maximum. If a bond length ever becomes :math:`> R_c`, LAMMPS "breaks" the bond, which means two things. First, the bond potential is turned off by setting its type to 0, and is no longer computed. Second, a pairwise interaction between the two atoms is turned on, since they @@ -75,7 +84,7 @@ Note that when bonds are dumped to a file via the :doc:`dump local ` comma status of broken bonds or permanently delete them, e.g.: -.. parsed-literal:: +.. code-block:: LAMMPS delete_bonds all stats delete_bonds all bond 0 remove @@ -124,8 +133,3 @@ Related commands :doc:`bond\_coeff `, :doc:`delete\_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_quartic.txt b/doc/txt/bond_quartic.txt deleted file mode 100644 index b7b1ee4ce6..0000000000 --- a/doc/txt/bond_quartic.txt +++ /dev/null @@ -1,112 +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 - -bond_style quartic command :h3 -bond_style quartic/omp command :h3 - -[Syntax:] - -bond_style quartic :pre - -[Examples:] - -bond_style quartic -bond_coeff 2 1200 -0.55 0.25 1.3 34.6878 :pre - -[Description:] - -The {quartic} bond style uses the potential - -:c,image(Eqs/bond_quartic.jpg) - -to define a bond that can be broken as the simulation proceeds (e.g. -due to a polymer being stretched). The sigma and epsilon used in the -LJ portion of the formula are both set equal to 1.0 by LAMMPS. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above, or in -the data file or restart files read by the "read_data"_read_data.html -or "read_restart"_read_restart.html commands: - -K (energy/distance^4) -B1 (distance) -B2 (distance) -Rc (distance) -U0 (energy) :ul - -This potential was constructed to mimic the FENE bond potential for -coarse-grained polymer chains. When monomers with sigma = epsilon = -1.0 are used, the following choice of parameters gives a quartic -potential that looks nearly like the FENE potential: K = 1200, B1 = --0.55, B2 = 0.25, Rc = 1.3, and U0 = 34.6878. Different parameters -can be specified using the "bond_coeff"_bond_coeff.html command, but -you will need to choose them carefully so they form a suitable bond -potential. - -Rc is the cutoff length at which the bond potential goes smoothly to a -local maximum. If a bond length ever becomes > Rc, LAMMPS "breaks" -the bond, which means two things. First, the bond potential is turned -off by setting its type to 0, and is no longer computed. Second, a -pairwise interaction between the two atoms is turned on, since they -are no longer bonded. - -LAMMPS does the second task via a computational sleight-of-hand. It -subtracts the pairwise interaction as part of the bond computation. -When the bond breaks, the subtraction stops. For this to work, the -pairwise interaction must always be computed by the -"pair_style"_pair_style.html command, whether the bond is broken or -not. This means that "special_bonds"_special_bonds.html must be set -to 1,1,1, as indicated as a restriction below. - -Note that when bonds are dumped to a file via the "dump -local"_dump.html command, bonds with type 0 are not included. The -"delete_bonds"_delete_bonds.html command can also be used to query the -status of broken bonds or permanently delete them, e.g.: - -delete_bonds all stats -delete_bonds all bond 0 remove :pre - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -instructions on how to use the accelerated styles effectively. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -The {quartic} style requires that "special_bonds"_special_bonds.html -parameters be set to 1,1,1. Three- and four-body interactions (angle, -dihedral, etc) cannot be used with {quartic} bonds. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From 9780fd3146b562f4311a77eef1a207865a65dec1 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:30:09 -0500 Subject: [PATCH 465/557] Update docs: bond_coeff --- doc/src/bond_coeff.rst | 23 +++++------- doc/txt/bond_coeff.txt | 82 ------------------------------------------ 2 files changed, 9 insertions(+), 96 deletions(-) delete mode 100644 doc/txt/bond_coeff.txt diff --git a/doc/src/bond_coeff.rst b/doc/src/bond_coeff.rst index 45b72cce91..281dfc7095 100644 --- a/doc/src/bond_coeff.rst +++ b/doc/src/bond_coeff.rst @@ -1,13 +1,13 @@ -.. index:: bond\_coeff +.. index:: bond_coeff -bond\_coeff command -=================== +bond_coeff command +================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_coeff N args @@ -18,11 +18,11 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_coeff 5 80.0 1.2 - bond_coeff \* 30.0 1.5 1.0 1.0 - bond_coeff 1\*4 30.0 1.5 1.0 1.0 + bond_coeff * 30.0 1.5 1.0 1.0 + bond_coeff 1*4 30.0 1.5 1.0 1.0 bond_coeff 1 harmonic 200.0 1.0 Description @@ -47,9 +47,9 @@ for the same bond type. For example, these commands set the coeffs for all bond types, then overwrite the coeffs for just bond type 2: -.. parsed-literal:: +.. code-block:: LAMMPS - bond_coeff \* 100.0 1.2 + bond_coeff * 100.0 1.2 bond_coeff 2 200.0 1.2 A line in a data file that specifies bond coefficients uses the exact @@ -97,8 +97,3 @@ Related commands :doc:`bond\_style ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_coeff.txt b/doc/txt/bond_coeff.txt deleted file mode 100644 index 1280ae3fb0..0000000000 --- a/doc/txt/bond_coeff.txt +++ /dev/null @@ -1,82 +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 - -bond_coeff command :h3 - -[Syntax:] - -bond_coeff N args :pre - -N = bond type (see asterisk form below) -args = coefficients for one or more bond types :ul - -[Examples:] - -bond_coeff 5 80.0 1.2 -bond_coeff * 30.0 1.5 1.0 1.0 -bond_coeff 1*4 30.0 1.5 1.0 1.0 -bond_coeff 1 harmonic 200.0 1.0 :pre - -[Description:] - -Specify the bond force field coefficients for one or more bond types. -The number and meaning of the coefficients depends on the bond style. -Bond coefficients can also be set in the data file read by the -"read_data"_read_data.html command or in a restart file. - -N can be specified in one of two ways. An explicit numeric value can -be used, as in the 1st example above. Or a wild-card asterisk can be -used to set the coefficients for multiple bond types. This takes the -form "*" or "*n" or "n*" or "m*n". If N = the number of bond types, -then an asterisk with no numeric values means all types from 1 to N. A -leading asterisk means all types from 1 to n (inclusive). A trailing -asterisk means all types from n to N (inclusive). A middle asterisk -means all types from m to n (inclusive). - -Note that using a bond_coeff command can override a previous setting -for the same bond type. For example, these commands set the coeffs -for all bond types, then overwrite the coeffs for just bond type 2: - -bond_coeff * 100.0 1.2 -bond_coeff 2 200.0 1.2 :pre - -A line in a data file that specifies bond coefficients uses the exact -same format as the arguments of the bond_coeff command in an input -script, except that wild-card asterisks should not be used since -coefficients for all N types must be listed in the file. For example, -under the "Bond Coeffs" section of a data file, the line that -corresponds to the 1st example above would be listed as - -5 80.0 1.2 :pre - -:line - -The list of all bond styles defined in LAMMPS is given on the -"bond_style"_bond_style.html doc page. They are also listed in more -compact form on the "Commands bond"_Commands_bond.html doc page. - -On either of those pages, click on the style to display the formula it -computes and its coefficients as specified by the associated -bond_coeff command. - -:line - -[Restrictions:] - -This command must come after the simulation box is defined by a -"read_data"_read_data.html, "read_restart"_read_restart.html, or -"create_box"_create_box.html command. - -A bond style must be defined before any bond coefficients are set, -either in the input script or in a data file. - -[Related commands:] - -"bond_style"_bond_style.html - -[Default:] none From c5c7e6953c37d5a77fa968fead23b2f63072f44b Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:35:06 -0500 Subject: [PATCH 466/557] Update docs: bond_write --- doc/src/bond_write.rst | 24 ++++++---------- doc/txt/bond_write.txt | 64 ------------------------------------------ 2 files changed, 9 insertions(+), 79 deletions(-) delete mode 100644 doc/txt/bond_write.txt diff --git a/doc/src/bond_write.rst b/doc/src/bond_write.rst index 23a6a04815..f7055d42aa 100644 --- a/doc/src/bond_write.rst +++ b/doc/src/bond_write.rst @@ -1,13 +1,13 @@ -.. index:: bond\_write +.. index:: bond_write -bond\_write command -=================== +bond_write command +================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_write btype N inner outer file keyword itype jtype @@ -17,13 +17,12 @@ Syntax * file = name of file to write values to * keyword = section name in file for this set of tabulated values * itype,jtype = 2 atom types (optional) -* Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_write 1 500 0.5 3.5 table.txt Harmonic_1 bond_write 3 1000 0.1 6.0 table.txt Morse @@ -40,14 +39,14 @@ file. The energy and force values are computed at distances from inner to outer for 2 interacting atoms forming a bond of type btype, using the -appropriate :doc:`bond\_coeff ` coefficients. N evenly spaced +appropriate :doc:`bond_coeff ` coefficients. N evenly spaced distances are used. For example, for N = 7, inner = 1.0, and outer = 4.0, values are computed at r = 1.0, 1.5, 2.0, 2.5, 3.0, 3.5, 4.0. The file is written in the format used as input for the -:doc:`bond\_style ` *table* option with *keyword* as the +:doc:`bond_style ` *table* option with *keyword* as the section name. Each line written to the file lists an index number (1-N), a distance (in distance units), an energy (in energy units), and a force (in force units). @@ -65,12 +64,7 @@ be specified even if the potential has a finite value at r = 0.0. Related commands """""""""""""""" -:doc:`bond\_style table `, -:doc:`bond\_style `, :doc:`bond\_coeff ` +:doc:`bond_style table `, +:doc:`bond_style `, :doc:`bond_coeff ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_write.txt b/doc/txt/bond_write.txt deleted file mode 100644 index 711bd2c296..0000000000 --- a/doc/txt/bond_write.txt +++ /dev/null @@ -1,64 +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 - -bond_write command :h3 - -[Syntax:] - -bond_write btype N inner outer file keyword itype jtype :pre - -btype = bond types -N = # of values -inner,outer = inner and outer bond length (distance units) -file = name of file to write values to -keyword = section name in file for this set of tabulated values -itype,jtype = 2 atom types (optional) -:ul - -[Examples:] - -bond_write 1 500 0.5 3.5 table.txt Harmonic_1 -bond_write 3 1000 0.1 6.0 table.txt Morse :pre - -[Description:] - -Write energy and force values to a file as a function of distance for -the currently defined bond potential. This is useful for plotting the -potential function or otherwise debugging its values. If the file -already exists, the table of values is appended to the end of the file -to allow multiple tables of energy and force to be included in one -file. - -The energy and force values are computed at distances from inner to -outer for 2 interacting atoms forming a bond of type btype, using the -appropriate "bond_coeff"_bond_coeff.html coefficients. N evenly spaced -distances are used. - -For example, for N = 7, inner = 1.0, and outer = 4.0, -values are computed at r = 1.0, 1.5, 2.0, 2.5, 3.0, 3.5, 4.0. - -The file is written in the format used as input for the -"bond_style"_bond_style.html {table} option with {keyword} as the -section name. Each line written to the file lists an index number -(1-N), a distance (in distance units), an energy (in energy units), -and a force (in force units). - -[Restrictions:] - -All force field coefficients for bond and other kinds of interactions -must be set before this command can be invoked. - -Due to how the bond force is computed, an inner value > 0.0 must -be specified even if the potential has a finite value at r = 0.0. - -[Related commands:] - -"bond_style table"_bond_table.html, -"bond_style"_bond_style.html, "bond_coeff"_bond_coeff.html - -[Default:] none From 2a900f85aafc4462a8394ed4562ca68beb9893b3 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:40:33 -0500 Subject: [PATCH 467/557] Update docs: bond_style --- doc/src/bond_style.rst | 27 ++++------ doc/txt/bond_style.txt | 115 ----------------------------------------- 2 files changed, 11 insertions(+), 131 deletions(-) delete mode 100644 doc/txt/bond_style.txt diff --git a/doc/src/bond_style.rst b/doc/src/bond_style.rst index f912411972..3c5c97b96b 100644 --- a/doc/src/bond_style.rst +++ b/doc/src/bond_style.rst @@ -1,29 +1,27 @@ -.. index:: bond\_style +.. index:: bond_style -bond\_style command -=================== +bond_style command +================== Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style style args * style = *none* or *hybrid* or *class2* or *fene* or *fene/expand* or *harmonic* or *morse* or *nonlinear* or *quartic* +* args = none for any style except *hybrid* -.. parsed-literal:: - - args = none for any style except *hybrid* - *hybrid* args = list of one or more styles + * *hybrid* args = list of one or more styles Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style harmonic bond_style fene @@ -74,11 +72,11 @@ between the 2 atoms in the bond. Here is an alphabetic list of bond styles defined in LAMMPS. Click on the style to display the formula it computes and coefficients -specified by the associated :doc:`bond\_coeff ` command. +specified by the associated :doc:`bond_coeff ` command. Click on the style to display the formula it computes, any additional arguments specified in the bond\_style command, and coefficients -specified by the associated :doc:`bond\_coeff ` command. +specified by the associated :doc:`bond_coeff ` command. There are also additional accelerated pair styles included in the LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. @@ -128,9 +126,6 @@ Related commands Default """"""" -bond\_style none +.. code-block:: LAMMPS - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html + bond_style none diff --git a/doc/txt/bond_style.txt b/doc/txt/bond_style.txt deleted file mode 100644 index aba6d3a778..0000000000 --- a/doc/txt/bond_style.txt +++ /dev/null @@ -1,115 +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 - -bond_style command :h3 - -[Syntax:] - -bond_style style args :pre - -style = {none} or {hybrid} or {class2} or {fene} or {fene/expand} or \ - {harmonic} or {morse} or {nonlinear} or {quartic} :ul - args = none for any style except {hybrid} - {hybrid} args = list of one or more styles :pre - -[Examples:] - -bond_style harmonic -bond_style fene -bond_style hybrid harmonic fene :pre - -[Description:] - -Set the formula(s) LAMMPS uses to compute bond interactions between -pairs of atoms. In LAMMPS, a bond differs from a pairwise -interaction, which are set via the "pair_style"_pair_style.html -command. Bonds are defined between specified pairs of atoms and -remain in force for the duration of the simulation (unless the bond -breaks which is possible in some bond potentials). The list of bonded -atoms is read in by a "read_data"_read_data.html or -"read_restart"_read_restart.html command from a data or restart file. -By contrast, pair potentials are typically defined between all pairs -of atoms within a cutoff distance and the set of active interactions -changes over time. - -Hybrid models where bonds are computed using different bond potentials -can be setup using the {hybrid} bond style. - -The coefficients associated with a bond style can be specified in a -data or restart file or via the "bond_coeff"_bond_coeff.html command. - -All bond potentials store their coefficient data in binary restart -files which means bond_style and "bond_coeff"_bond_coeff.html commands -do not need to be re-specified in an input script that restarts a -simulation. See the "read_restart"_read_restart.html command for -details on how to do this. The one exception is that bond_style -{hybrid} only stores the list of sub-styles in the restart file; bond -coefficients need to be re-specified. - -NOTE: When both a bond and pair style is defined, the -"special_bonds"_special_bonds.html command often needs to be used to -turn off (or weight) the pairwise interaction that would otherwise -exist between 2 bonded atoms. - -In the formulas listed for each bond style, {r} is the distance -between the 2 atoms in the bond. - -:line - -Here is an alphabetic list of bond styles defined in LAMMPS. Click on -the style to display the formula it computes and coefficients -specified by the associated "bond_coeff"_bond_coeff.html command. - -Click on the style to display the formula it computes, any additional -arguments specified in the bond_style command, and coefficients -specified by the associated "bond_coeff"_bond_coeff.html command. - -There are also additional accelerated pair styles included in the -LAMMPS distribution for faster performance on CPUs, GPUs, and KNLs. -The individual style names on the "Commands bond"_Commands_bond.html -doc page are followed by one or more of (g,i,k,o,t) to indicate which -accelerated styles exist. - -"none"_bond_none.html - turn off bonded interactions -"zero"_bond_zero.html - topology but no interactions -"hybrid"_bond_hybrid.html - define multiple styles of bond interactions :ul - -"class2"_bond_class2.html - COMPASS (class 2) bond -"fene"_bond_fene.html - FENE (finite-extensible non-linear elastic) bond -"fene/expand"_bond_fene_expand.html - FENE bonds with variable size particles -"gromos"_bond_gromos.html - GROMOS force field bond -"harmonic"_bond_harmonic.html - harmonic bond -"harmonic/shift"_bond_harmonic_shift.html - shifted harmonic bond -"harmonic/shift/cut"_bond_harmonic_shift_cut.html - shifted harmonic bond with a cutoff -"mm3"_bond_mm3.html - MM3 anharmonic bond -"morse"_bond_morse.html - Morse bond -"nonlinear"_bond_nonlinear.html - nonlinear bond -"oxdna/fene"_bond_oxdna.html - modified FENE bond suitable for DNA modeling -"oxdna2/fene"_bond_oxdna.html - same as oxdna but used with different pair styles -"quartic"_bond_quartic.html - breakable quartic bond -"table"_bond_table.html - tabulated by bond length :ul - -:line - -[Restrictions:] - -Bond styles can only be set for atom styles that allow bonds to be -defined. - -Most bond styles are part of the MOLECULE package. They are only -enabled if LAMMPS was built with that package. See the "Build -package"_Build_package.html doc page for more info. The doc pages for -individual bond potentials tell if it is part of a package. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] - -bond_style none From 18a86a90efbcc5b8a1b5fb4fc215492230ad003d Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:44:28 -0500 Subject: [PATCH 468/557] Update docs: bond_zero --- doc/src/bond_zero.rst | 21 ++++++++----------- doc/txt/bond_zero.txt | 48 ------------------------------------------- 2 files changed, 8 insertions(+), 61 deletions(-) delete mode 100644 doc/txt/bond_zero.txt diff --git a/doc/src/bond_zero.rst b/doc/src/bond_zero.rst index 38e7ecf505..43a0af33e2 100644 --- a/doc/src/bond_zero.rst +++ b/doc/src/bond_zero.rst @@ -1,26 +1,26 @@ -.. index:: bond\_style zero +.. index:: bond_style zero -bond\_style zero command -======================== +bond_style zero command +======================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS - bond_style zero *nocoeff* + bond_style zero [nocoeff] Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style zero bond_style zero nocoeff - bond_coeff \* - bond_coeff \* 2.14 + bond_coeff * + bond_coeff * 2.14 Description """"""""""" @@ -53,8 +53,3 @@ Related commands :doc:`bond\_style none ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_zero.txt b/doc/txt/bond_zero.txt deleted file mode 100644 index 554f26e7f0..0000000000 --- a/doc/txt/bond_zero.txt +++ /dev/null @@ -1,48 +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 - -bond_style zero command :h3 - -[Syntax:] - -bond_style zero {nocoeff} :pre - -[Examples:] - -bond_style zero -bond_style zero nocoeff -bond_coeff * -bond_coeff * 2.14 :pre - -[Description:] - -Using an bond style of zero means bond forces and energies are not -computed, but the geometry of bond pairs is still accessible to other -commands. - -As an example, the "compute bond/local"_compute_bond_local.html -command can be used to compute distances for the list of pairs of bond -atoms listed in the data file read by the "read_data"_read_data.html -command. If no bond style is defined, this command cannot be used. - -The optional {nocoeff} flag allows to read data files with a BondCoeff -section for any bond style. Similarly, any bond_coeff commands -will only be checked for the bond type number and the rest ignored. - -Note that the "bond_coeff"_bond_coeff.html command must be used for -all bond types. If specified, there can be only one value, which is -going to be used to assign an equilibrium distance, e.g. for use with -"fix shake"_fix_shake.html. - -[Restrictions:] none - -[Related commands:] - -"bond_style none"_bond_none.html - -[Default:] none From 1b4e84de94f589109a3adb1fd82b2f540a63d45a Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:46:53 -0500 Subject: [PATCH 469/557] Update docs: bond_none --- doc/src/bond_none.rst | 21 ++++++++------------- doc/txt/bond_none.txt | 34 ---------------------------------- 2 files changed, 8 insertions(+), 47 deletions(-) delete mode 100644 doc/txt/bond_none.txt diff --git a/doc/src/bond_none.rst b/doc/src/bond_none.rst index dde5b6d29a..ac838581be 100644 --- a/doc/src/bond_none.rst +++ b/doc/src/bond_none.rst @@ -1,13 +1,13 @@ -.. index:: bond\_style none +.. index:: bond_style none -bond\_style none command -======================== +bond_style none command +======================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style none @@ -15,7 +15,7 @@ Examples """""""" -.. parsed-literal:: +.. code-blocK:: LAMMPS bond_style none @@ -24,9 +24,9 @@ Description Using a bond style of none means bond forces and energies are not computed, even if pairs of bonded atoms were listed in the data file -read by the :doc:`read\_data ` command. +read by the :doc:`read_data ` command. -See the :doc:`bond\_style zero ` command for a way to +See the :doc:`bond_style zero ` command for a way to calculate bond statistics, but compute no bond interactions. Restrictions @@ -35,11 +35,6 @@ Restrictions **Related commands:** none -:doc:`bond\_style zero ` +:doc:`bond_style zero ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_none.txt b/doc/txt/bond_none.txt deleted file mode 100644 index cace1919e1..0000000000 --- a/doc/txt/bond_none.txt +++ /dev/null @@ -1,34 +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 - -bond_style none command :h3 - -[Syntax:] - -bond_style none :pre - -[Examples:] - -bond_style none :pre - -[Description:] - -Using a bond style of none means bond forces and energies are not -computed, even if pairs of bonded atoms were listed in the data file -read by the "read_data"_read_data.html command. - -See the "bond_style zero"_bond_zero.html command for a way to -calculate bond statistics, but compute no bond interactions. - -[Restrictions:] none - -[Related commands:] none - -"bond_style zero"_bond_zero.html - -[Default:] none From ff9f93bbf69d19d4fdbd269a93f6729ceaedb0a1 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:51:46 -0500 Subject: [PATCH 470/557] Update docs: bond_table --- doc/src/bond_table.rst | 31 ++++---- doc/txt/bond_table.txt | 163 ----------------------------------------- 2 files changed, 13 insertions(+), 181 deletions(-) delete mode 100644 doc/txt/bond_table.txt diff --git a/doc/src/bond_table.rst b/doc/src/bond_table.rst index f68288349d..c12ea8af44 100644 --- a/doc/src/bond_table.rst +++ b/doc/src/bond_table.rst @@ -1,16 +1,16 @@ -.. index:: bond\_style table +.. index:: bond_style table -bond\_style table command -========================= +bond_style table command +======================== -bond\_style table/omp command -============================= +bond_style table/omp command +============================ Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style table style N @@ -21,7 +21,7 @@ Examples """""""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style table linear 1000 bond_coeff 1 file.table ENTRY1 @@ -31,14 +31,14 @@ Description Style *table* creates interpolation tables of length *N* from bond potential and force values listed in a file(s) as a function of bond -length. The files are read by the :doc:`bond\_coeff ` +length. The files are read by the :doc:`bond_coeff ` command. The interpolation tables are created by fitting cubic splines to the file values and interpolating energy and force values at each of *N* distances. During a simulation, these tables are used to interpolate energy and force values as needed. The interpolation is done in one -of 2 styles: *linear* or *spline*\ . +of 2 styles: *linear* or *spline*. For the *linear* style, the bond length is used to find 2 surrounding table values from which an energy or force is computed by linear @@ -50,7 +50,7 @@ used to find the appropriate set of coefficients which are used to evaluate a cubic polynomial which computes the energy or force. The following coefficients must be defined for each bond type via the -:doc:`bond\_coeff ` command as in the example above. +:doc:`bond_coeff ` command as in the example above. * filename * keyword @@ -84,14 +84,14 @@ A section begins with a non-blank line whose 1st character is not a between sections. The first line begins with a keyword which identifies the section. The line can contain additional text, but the initial text must match the argument specified in the -:doc:`bond\_coeff ` command. The next line lists (in any +:doc:`bond_coeff ` command. The next line lists (in any order) one or more parameters for the table. Each parameter is a keyword followed by one or more numeric values. The parameter "N" is required and its value is the number of table entries that follow. Note that this may be different than the *N* specified in the :doc:`bond\_style table ` command. Let -Ntable = *N* in the bond\_style command, and Nfile = "N" in the +Ntable = *N* in the bond_style command, and Nfile = "N" in the tabulated file. What LAMMPS does is a preliminary interpolation by creating splines using the Nfile tabulated values as nodal points. It uses these to interpolate as needed to generate energy and force @@ -173,11 +173,6 @@ info. Related commands """""""""""""""" -:doc:`bond\_coeff `, :doc:`delete\_bonds ` +:doc:`bond_coeff `, :doc:`delete_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_table.txt b/doc/txt/bond_table.txt deleted file mode 100644 index 7235214af0..0000000000 --- a/doc/txt/bond_table.txt +++ /dev/null @@ -1,163 +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 - -bond_style table command :h3 -bond_style table/omp command :h3 - -[Syntax:] - -bond_style table style N :pre - -style = {linear} or {spline} = method of interpolation -N = use N values in table :ul - -[Examples:] - -bond_style table linear 1000 -bond_coeff 1 file.table ENTRY1 :pre - -[Description:] - -Style {table} creates interpolation tables of length {N} from bond -potential and force values listed in a file(s) as a function of bond -length. The files are read by the "bond_coeff"_bond_coeff.html -command. - -The interpolation tables are created by fitting cubic splines to the -file values and interpolating energy and force values at each of {N} -distances. During a simulation, these tables are used to interpolate -energy and force values as needed. The interpolation is done in one -of 2 styles: {linear} or {spline}. - -For the {linear} style, the bond length is used to find 2 surrounding -table values from which an energy or force is computed by linear -interpolation. - -For the {spline} style, a cubic spline coefficients are computed and -stored at each of the {N} values in the table. The bond length is -used to find the appropriate set of coefficients which are used to -evaluate a cubic polynomial which computes the energy or force. - -The following coefficients must be defined for each bond type via the -"bond_coeff"_bond_coeff.html command as in the example above. - -filename -keyword :ul - -The filename specifies a file containing tabulated energy and force -values. The keyword specifies a section of the file. The format of -this file is described below. - -:line - -The format of a tabulated file is as follows (without the -parenthesized comments): - -# Bond potential for harmonic (one or more comment or blank lines) :pre - -HAM (keyword is the first text on line) -N 101 FP 0 0 EQ 0.5 (N, FP, EQ parameters) - (blank line) -1 0.00 338.0000 1352.0000 (index, bond-length, energy, force) -2 0.01 324.6152 1324.9600 -... -101 1.00 338.0000 -1352.0000 :pre - -A section begins with a non-blank line whose 1st character is not a -"#"; blank lines or lines starting with "#" can be used as comments -between sections. The first line begins with a keyword which -identifies the section. The line can contain additional text, but the -initial text must match the argument specified in the -"bond_coeff"_bond_coeff.html command. The next line lists (in any -order) one or more parameters for the table. Each parameter is a -keyword followed by one or more numeric values. - -The parameter "N" is required and its value is the number of table -entries that follow. Note that this may be different than the {N} -specified in the "bond_style table"_bond_style.html command. Let -Ntable = {N} in the bond_style command, and Nfile = "N" in the -tabulated file. What LAMMPS does is a preliminary interpolation by -creating splines using the Nfile tabulated values as nodal points. It -uses these to interpolate as needed to generate energy and force -values at Ntable different points. The resulting tables of length -Ntable are then used as described above, when computing energy and -force for individual bond lengths. This means that if you want the -interpolation tables of length Ntable to match exactly what is in the -tabulated file (with effectively no preliminary interpolation), you -should set Ntable = Nfile. - -The "FP" parameter is optional. If used, it is followed by two values -fplo and fphi, which are the derivatives of the force at the innermost -and outermost bond lengths. These values are needed by the spline -construction routines. If not specified by the "FP" parameter, they -are estimated (less accurately) by the first two and last two force -values in the table. - -The "EQ" parameter is also optional. If used, it is followed by a the -equilibrium bond length, which is used, for example, by the "fix -shake"_fix_shake.html command. If not used, the equilibrium bond -length is to the distance in the table with the lowest potential energy. - -Following a blank line, the next N lines list the tabulated values. -On each line, the 1st value is the index from 1 to N, the 2nd value is -the bond length r (in distance units), the 3rd value is the energy (in -energy units), and the 4th is the force (in force units). The bond -lengths must range from a LO value to a HI value, and increase from -one line to the next. If the actual bond length is ever smaller than -the LO value or larger than the HI value, then the bond energy and -force is evaluated as if the bond were the LO or HI length. - -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. - -:line - -Styles with a {gpu}, {intel}, {kk}, {omp}, or {opt} suffix are -functionally the same as the corresponding style without the suffix. -They have been optimized to run faster, depending on your available -hardware, as discussed on the "Speed packages"_Speed_packages.html doc -page. The accelerated styles take the same arguments and should -produce the same results, except for round-off and precision issues. - -These accelerated styles are part of the GPU, USER-INTEL, KOKKOS, -USER-OMP and OPT packages, respectively. They are only enabled if -LAMMPS was built with those packages. See the "Build -package"_Build_package.html doc page for more info. - -You can specify the accelerated styles explicitly in your input script -by including their suffix, or you can use the "-suffix command-line -switch"_Run_options.html when you invoke LAMMPS, or you can use the -"suffix"_suffix.html command in your input script. - -See the "Speed packages"_Speed_packages.html doc page for more -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 -package. See the "Build package"_Build_package.html doc page for more -info. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From d6b1e302f297cddd402afa4a78f68136db66ca89 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 22:59:34 -0500 Subject: [PATCH 471/557] Update docs: bond_hybrid --- doc/src/bond_hybrid.rst | 27 ++++++--------- doc/txt/bond_hybrid.txt | 74 ----------------------------------------- 2 files changed, 11 insertions(+), 90 deletions(-) delete mode 100644 doc/txt/bond_hybrid.txt diff --git a/doc/src/bond_hybrid.rst b/doc/src/bond_hybrid.rst index 34297c2ff9..6b8175858f 100644 --- a/doc/src/bond_hybrid.rst +++ b/doc/src/bond_hybrid.rst @@ -1,13 +1,13 @@ -.. index:: bond\_style hybrid +.. index:: bond_style hybrid -bond\_style hybrid command -========================== +bond_style hybrid command +========================= Syntax """""" -.. parsed-literal:: +.. code-block:: LAMMPS bond_style hybrid style1 style2 ... @@ -17,11 +17,11 @@ Examples """""""" -.. parsed-literal:: +.. code-block: LAMMPS bond_style hybrid harmonic fene bond_coeff 1 harmonic 80.0 1.2 - bond_coeff 2\* fene 30.0 1.5 1.0 1.0 + bond_coeff 2* fene 30.0 1.5 1.0 1.0 Description """"""""""" @@ -31,19 +31,19 @@ simulation. A bond style is assigned to each bond type. For example, bonds in a polymer flow (of bond type 1) could be computed with a *fene* potential and bonds in the wall boundary (of bond type 2) could be computed with a *harmonic* potential. The assignment of bond type -to style is made via the :doc:`bond\_coeff ` command or in +to style is made via the :doc:`bond_coeff ` command or in the data file. In the bond\_coeff commands, the name of a bond style must be added after the bond type, with the remaining coefficients being those appropriate to that style. In the example above, the 2 bond\_coeff commands set bonds of bond type 1 to be computed with a *harmonic* -potential with coefficients 80.0, 1.2 for K, r0. All other bond types +potential with coefficients 80.0, 1.2 for :math:`K`, :math:`r_0`. All other bond types (2-N) are computed with a *fene* potential with coefficients 30.0, -1.5, 1.0, 1.0 for K, R0, epsilon, sigma. +1.5, 1.0, 1.0 for :math:`K`, :math:`R_0`, :math:`\epsilon`, :math:`\sigma`. If bond coefficients are specified in the data file read via the -:doc:`read\_data ` command, then the same rule applies. +:doc:`read_data ` command, then the same rule applies. E.g. "harmonic" or "fene" must be added after the bond type, for each line in the "Bond Coeffs" section, e.g. @@ -80,11 +80,6 @@ file, you need to re-specify bond\_coeff commands. Related commands """""""""""""""" -:doc:`bond\_coeff `, :doc:`delete\_bonds ` +:doc:`bond_coeff `, :doc:`delete_bonds ` **Default:** none - - -.. _lws: http://lammps.sandia.gov -.. _ld: Manual.html -.. _lc: Commands_all.html diff --git a/doc/txt/bond_hybrid.txt b/doc/txt/bond_hybrid.txt deleted file mode 100644 index 0996f72ce3..0000000000 --- a/doc/txt/bond_hybrid.txt +++ /dev/null @@ -1,74 +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 - -bond_style hybrid command :h3 - -[Syntax:] - -bond_style hybrid style1 style2 ... :pre - -style1,style2 = list of one or more bond styles :ul - -[Examples:] - -bond_style hybrid harmonic fene -bond_coeff 1 harmonic 80.0 1.2 -bond_coeff 2* fene 30.0 1.5 1.0 1.0 :pre - -[Description:] - -The {hybrid} style enables the use of multiple bond styles in one -simulation. A bond style is assigned to each bond type. For example, -bonds in a polymer flow (of bond type 1) could be computed with a -{fene} potential and bonds in the wall boundary (of bond type 2) could -be computed with a {harmonic} potential. The assignment of bond type -to style is made via the "bond_coeff"_bond_coeff.html command or in -the data file. - -In the bond_coeff commands, the name of a bond style must be added -after the bond type, with the remaining coefficients being those -appropriate to that style. In the example above, the 2 bond_coeff -commands set bonds of bond type 1 to be computed with a {harmonic} -potential with coefficients 80.0, 1.2 for K, r0. All other bond types -(2-N) are computed with a {fene} potential with coefficients 30.0, -1.5, 1.0, 1.0 for K, R0, epsilon, sigma. - -If bond coefficients are specified in the data file read via the -"read_data"_read_data.html command, then the same rule applies. -E.g. "harmonic" or "fene" must be added after the bond type, for each -line in the "Bond Coeffs" section, e.g. - -Bond Coeffs :pre - -1 harmonic 80.0 1.2 -2 fene 30.0 1.5 1.0 1.0 -... :pre - -A bond style of {none} with no additional coefficients can be used in -place of a bond style, either in a input script bond_coeff command or -in the data file, if you desire to turn off interactions for specific -bond types. - -:line - -[Restrictions:] - -This bond style can only be used if LAMMPS was built with the MOLECULE -package. See the "Build package"_Build_package.html doc page for more -info. - -Unlike other bond styles, the hybrid bond style does not store bond -coefficient info for individual sub-styles in a "binary restart -files"_restart.html. Thus when restarting a simulation from a restart -file, you need to re-specify bond_coeff commands. - -[Related commands:] - -"bond_coeff"_bond_coeff.html, "delete_bonds"_delete_bonds.html - -[Default:] none From 3ff3621efac20659b6e55fc09abf90b604bc12ff Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 23:17:08 -0500 Subject: [PATCH 472/557] Fix pdf build --- doc/src/bond_harmonic_shift_cut.rst | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/doc/src/bond_harmonic_shift_cut.rst b/doc/src/bond_harmonic_shift_cut.rst index 0ea9a3a968..459acfdbfb 100644 --- a/doc/src/bond_harmonic_shift_cut.rst +++ b/doc/src/bond_harmonic_shift_cut.rst @@ -36,7 +36,7 @@ uses the potential where :math:`r_0` is the equilibrium bond distance, and rc the critical distance. The bond potential is zero for distances :math:`r > r_c`. The potential is :math:`-U_{\text{min}}` -at :math:`r_0` and zero at :math:`r_c`. The spring constant is :math:`k = U_{\text{min}} / [ 2 (r_0-r_c)\^2]`. +at :math:`r_0` and zero at :math:`r_c`. The spring constant is :math:`k = U_{\text{min}} / [ 2 (r_0-r_c)^2]`. The following coefficients must be defined for each bond type via the :doc:`bond\_coeff ` command as in the example above, or in From 19b265f845b229ca924220b4732ee9702e49cc59 Mon Sep 17 00:00:00 2001 From: Richard Berger Date: Sat, 16 Nov 2019 23:57:12 -0500 Subject: [PATCH 473/557] Update CMake-based doc build --- cmake/Modules/Documentation.cmake | 23 +++-------------------- 1 file changed, 3 insertions(+), 20 deletions(-) diff --git a/cmake/Modules/Documentation.cmake b/cmake/Modules/Documentation.cmake index 99f570820a..feff66a9b2 100644 --- a/cmake/Modules/Documentation.cmake +++ b/cmake/Modules/Documentation.cmake @@ -9,9 +9,7 @@ if(BUILD_DOC) set(VIRTUALENV ${PYTHON_EXECUTABLE} -m virtualenv) - file(GLOB DOC_SOURCES ${LAMMPS_DOC_DIR}/src/[^.]*.txt) - file(GLOB PDF_EXTRA_SOURCES ${LAMMPS_DOC_DIR}/src/lammps_commands*.txt ${LAMMPS_DOC_DIR}/src/lammps_support.txt ${LAMMPS_DOC_DIR}/src/lammps_tutorials.txt) - list(REMOVE_ITEM DOC_SOURCES ${PDF_EXTRA_SOURCES}) + file(GLOB DOC_SOURCES ${LAMMPS_DOC_DIR}/src/[^.]*.rst) add_custom_command( OUTPUT docenv @@ -28,25 +26,10 @@ if(BUILD_DOC) COMMAND ${DOCENV_BINARY_DIR}/pip install --upgrade ${LAMMPS_DOC_DIR}/utils/converters ) - set(RST_FILES "") - set(RST_DIR ${CMAKE_BINARY_DIR}/rst) - file(MAKE_DIRECTORY ${RST_DIR}) - foreach(TXT_FILE ${DOC_SOURCES}) - get_filename_component(FILENAME ${TXT_FILE} NAME_WE) - set(RST_FILE ${RST_DIR}/${FILENAME}.rst) - list(APPEND RST_FILES ${RST_FILE}) - add_custom_command( - OUTPUT ${RST_FILE} - DEPENDS requirements.txt docenv ${TXT_FILE} - COMMAND ${DOCENV_BINARY_DIR}/txt2rst -o ${RST_DIR} ${TXT_FILE} - ) - endforeach() - add_custom_command( OUTPUT html - DEPENDS ${RST_FILES} - COMMAND ${CMAKE_COMMAND} -E copy_directory ${LAMMPS_DOC_DIR}/src ${RST_DIR} - COMMAND ${DOCENV_BINARY_DIR}/sphinx-build -j ${NPROCS} -b html -c ${LAMMPS_DOC_DIR}/utils/sphinx-config -d ${CMAKE_BINARY_DIR}/doctrees ${RST_DIR} html + DEPENDS ${DOC_SOURCES} docenv requirements.txt + COMMAND ${DOCENV_BINARY_DIR}/sphinx-build -j ${NPROCS} -b html -c ${LAMMPS_DOC_DIR}/utils/sphinx-config -d ${CMAKE_BINARY_DIR}/doctrees ${LAMMPS_DOC_DIR}/src html ) add_custom_target( From 2fea49741f66b1d3c2d3e3d6303be596513bd695 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 17 Nov 2019 16:50:16 -0700 Subject: [PATCH 474/557] Fixed some problems with type offsets --- src/SNAP/compute_snap.cpp | 188 +++++++++++++++++--------------------- src/SNAP/compute_snap.h | 4 +- 2 files changed, 88 insertions(+), 104 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 5c472861ec..904d75a8e3 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -20,7 +20,7 @@ -DONE: size_peratom = (3+6)*nperdim*ntypes INCOMPLETE: Mappy from local to global INCOMPLETE: modify->find_compute() -INCOMPLETE: eliminate local peratom array for viral, replace with fdotr +DONE: eliminate local peratom array for viral, replace with fdotr */ #include "compute_snap.h" @@ -129,14 +129,15 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ncoeff = snaptr->ncoeff; nperdim = ncoeff; if (quadraticflag) nperdim += (ncoeff*(ncoeff+1))/2; + ndims_force = 3; + ndims_virial = 6; yoffset = nperdim; zoffset = 2*nperdim; - virialoffset = 3*nperdim; natoms = atom->natoms; - size_array_rows = 1+3*natoms+6; - size_array_cols = nperdim*atom->ntypes+1; // extra col for reference potential - ndims_peratom = 9; - size_peratom = ndims_peratom*nperdim*atom->ntypes; // local atom force and virial data + size_array_rows = 1+ndims_force*natoms+ndims_virial; + size_array_cols = nperdim*atom->ntypes+1; + ndims_peratom = ndims_force; + size_peratom = ndims_peratom*nperdim*atom->ntypes; comm_reverse = size_peratom; nmax = 0; @@ -182,8 +183,6 @@ void ComputeSnap::init() // allocate memory for global array - // printf("allocate memory for global array rows = %d cols = %d\n", - // size_array_rows,size_array_cols); memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); array = snap; @@ -197,6 +196,8 @@ void ComputeSnap::init() char *id_pe = (char *) "thermo_pe"; int ipe = modify->find_compute(id_pe); + if (ipe == -1) + error->all(FLERR,"compute thermo_pe does not exist."); c_pe = modify->compute[ipe]; // add compute for reference virial tensor @@ -204,7 +205,7 @@ void ComputeSnap::init() char *id_virial = (char *) "snap_press"; int ivirial = modify->find_compute(id_virial); if (ivirial == -1) - error->all(FLERR,"compute snap requires that compute snap_press exists!"); + error->all(FLERR,"compute snap requires that compute snap_press exists."); c_virial = modify->compute[ivirial]; } @@ -224,8 +225,6 @@ void ComputeSnap::compute_array() invoked_array = update->ntimestep; - // printf("Invoking compute snap on timestep %d\n",invoked_array); - // grow snap_peratom array if necessary if (atom->nmax > nmax) { @@ -236,12 +235,12 @@ void ComputeSnap::compute_array() } // clear global array - // only need to zero out first row + // only need to zero out first row of bispectrum - for (int icoeff = 0; icoeff < size_array_cols; icoeff++) + for (int icoeff = 0; icoeff < size_array_cols-1; icoeff++) snap[0][icoeff] = 0.0; - // clear peratom array + // clear local peratom array for (int i = 0; i < ntotal; i++) for (int icoeff = 0; icoeff < size_peratom; icoeff++) { @@ -275,7 +274,8 @@ void ComputeSnap::compute_array() const double radi = radelem[itype]; const int* const jlist = firstneigh[i]; const int jnum = numneigh[i]; - const int typeoffset = ndims_peratom*nperdim*(atom->type[i]-1); + const int typeoffset_local = ndims_peratom*nperdim*(itype-1); + const int typeoffset_global = nperdim*(itype-1); // insure rij, inside, and typej are of size jnum @@ -309,9 +309,7 @@ void ComputeSnap::compute_array() snaptr->compute_ui(ninside); snaptr->compute_zi(); - // if (quadraticflag) { snaptr->compute_bi(); - // } for (int jj = 0; jj < ninside; jj++) { const int j = snaptr->inside[jj]; @@ -322,10 +320,8 @@ void ComputeSnap::compute_array() // Accumulate -dBi/dRi, -dBi/dRj - double *snadi = snap_peratom[i]+typeoffset; - double *snadj = snap_peratom[j]+typeoffset; - double *snavi = snadi+virialoffset; - double *snavj = snadj+virialoffset; + double *snadi = snap_peratom[i]+typeoffset_local; + double *snadj = snap_peratom[j]+typeoffset_local; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { snadi[icoeff] += snaptr->dblist[icoeff][0]; @@ -334,27 +330,12 @@ void ComputeSnap::compute_array() snadj[icoeff] -= snaptr->dblist[icoeff][0]; snadj[icoeff+yoffset] -= snaptr->dblist[icoeff][1]; snadj[icoeff+zoffset] -= snaptr->dblist[icoeff][2]; - - snavi[icoeff] += snaptr->dblist[icoeff][0]*xtmp; - snavi[icoeff+nperdim] += snaptr->dblist[icoeff][1]*ytmp; - snavi[icoeff+2*nperdim] += snaptr->dblist[icoeff][2]*ztmp; - snavi[icoeff+3*nperdim] += snaptr->dblist[icoeff][1]*ztmp; - snavi[icoeff+4*nperdim] += snaptr->dblist[icoeff][0]*ztmp; - snavi[icoeff+5*nperdim] += snaptr->dblist[icoeff][0]*ytmp; - snavj[icoeff] -= snaptr->dblist[icoeff][0]*x[j][0]; - snavj[icoeff+nperdim] -= snaptr->dblist[icoeff][1]*x[j][1]; - snavj[icoeff+2*nperdim] -= snaptr->dblist[icoeff][2]*x[j][2]; - snavj[icoeff+3*nperdim] -= snaptr->dblist[icoeff][1]*x[j][2]; - snavj[icoeff+4*nperdim] -= snaptr->dblist[icoeff][0]*x[j][2]; - snavj[icoeff+5*nperdim] -= snaptr->dblist[icoeff][0]*x[j][1]; } if (quadraticflag) { const int quadraticoffset = ncoeff; snadi += quadraticoffset; snadj += quadraticoffset; - snavi += quadraticoffset; - snavj += quadraticoffset; int ncount = 0; for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bi = snaptr->blist[icoeff]; @@ -375,19 +356,6 @@ void ComputeSnap::compute_array() snadj[ncount+yoffset] -= dbytmp; snadj[ncount+zoffset] -= dbztmp; - snavi[ncount] += dbxtmp*xtmp; - snavi[ncount+nperdim] += dbytmp*ytmp; - snavi[ncount+2*nperdim] += dbztmp*ztmp; - snavi[ncount+3*nperdim] += dbytmp*ztmp; - snavi[ncount+4*nperdim] += dbxtmp*ztmp; - snavi[ncount+5*nperdim] += dbxtmp*ytmp; - snavj[ncount] -= dbxtmp*x[j][0]; - snavj[ncount+nperdim] -= dbytmp*x[j][1]; - snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; - snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; - snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; - snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; - ncount++; // upper-triangular elements of quadratic matrix @@ -407,22 +375,10 @@ void ComputeSnap::compute_array() snadj[ncount+yoffset] -= dbytmp; snadj[ncount+zoffset] -= dbztmp; - snavi[ncount] += dbxtmp*xtmp; - snavi[ncount+nperdim] += dbytmp*ytmp; - snavi[ncount+2*nperdim] += dbztmp*ztmp; - snavi[ncount+3*nperdim] += dbytmp*ztmp; - snavi[ncount+4*nperdim] += dbxtmp*ztmp; - snavi[ncount+5*nperdim] += dbxtmp*ytmp; - snavj[ncount] -= dbxtmp*x[j][0]; - snavj[ncount+nperdim] -= dbytmp*x[j][1]; - snavj[ncount+2*nperdim] -= dbztmp*x[j][2]; - snavj[ncount+3*nperdim] -= dbytmp*x[j][2]; - snavj[ncount+4*nperdim] -= dbxtmp*x[j][2]; - snavj[ncount+5*nperdim] -= dbxtmp*x[j][1]; - ncount++; } } + } } @@ -448,65 +404,39 @@ void ComputeSnap::compute_array() } } - // INCOMPLETE - // can get rid of virial from snap_peratom by doing - // equivalent of Pair::virial_fdotr_compute() - // before reverse communicate of snap_peratom + // accumulate virial contributions before reverse compute - // communicate snap contributions between neighbor procs + dbdotr_compute(); + + // communicate local peratom contributions between neighbor procs comm->reverse_comm_compute(this); - // construct global array + // copy peratom data to global array + // INCOMPLETE ignore local-global mapping for now for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset = 3*nperdim*itype; + const int typeoffset_local = ndims_peratom*nperdim*itype; + const int typeoffset_global = nperdim*itype; for (int icoeff = 0; icoeff < nperdim; icoeff++) { - - // assign force rows - // INCOMPLETE ignore local-global mapping for now - int irow = 1; for (int i = 0; i < atom->nlocal; i++) { - double *snadi = snap_peratom[i]+typeoffset; - snap[irow++][icoeff+typeoffset] = snadi[icoeff]; - snap[irow++][icoeff+typeoffset] = snadi[icoeff+yoffset]; - snap[irow++][icoeff+typeoffset] = snadi[icoeff+zoffset]; - + double *snadi = snap_peratom[i]+typeoffset_local; + snap[irow++][icoeff+typeoffset_global] = snadi[icoeff]; + snap[irow++][icoeff+typeoffset_global] = snadi[icoeff+yoffset]; + snap[irow++][icoeff+typeoffset_global] = snadi[icoeff+zoffset]; } - - // assign virial row - - int irow0 = irow; - snap[irow++][icoeff+typeoffset] = 0.0; - snap[irow++][icoeff+typeoffset] = 0.0; - snap[irow++][icoeff+typeoffset] = 0.0; - snap[irow++][icoeff+typeoffset] = 0.0; - snap[irow++][icoeff+typeoffset] = 0.0; - snap[irow++][icoeff+typeoffset] = 0.0; - - for (int i = 0; i < atom->nlocal; i++) { - double *snavi = snap_peratom[i]+typeoffset+virialoffset; - irow = irow0; - snap[irow++][icoeff+typeoffset] += snavi[icoeff]; - snap[irow++][icoeff+typeoffset] += snavi[icoeff+1*nperdim]; - snap[irow++][icoeff+typeoffset] += snavi[icoeff+2*nperdim]; - snap[irow++][icoeff+typeoffset] += snavi[icoeff+3*nperdim]; - snap[irow++][icoeff+typeoffset] += snavi[icoeff+4*nperdim]; - snap[irow++][icoeff+typeoffset] += snavi[icoeff+5*nperdim]; - } - } } - // assign energy row + // assign energy to last column int icol = size_array_cols-1; int irow = 0; double reference_energy = c_pe->compute_scalar(); snap[irow++][icol] = reference_energy; - // assign force rows + // assign forces to last column // INCOMPLETE ignore local-global mapping for now for (int i = 0; i < atom->nlocal; i++) { @@ -515,7 +445,7 @@ void ComputeSnap::compute_array() snap[irow++][icol] = atom->f[i][2]; } - // assign virial row + // assign virial stress to last column // switch to Voigt notation c_virial->compute_vector(); @@ -556,6 +486,58 @@ void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) } } +/* ---------------------------------------------------------------------- + compute global virial contributions via summing dB dot r over + own & ghost atoms, before reverse comm. +------------------------------------------------------------------------- */ + +void ComputeSnap::dbdotr_compute() +{ + double **x = atom->x; + int irow0 = 1+ndims_peratom*natoms; + + // zero virial entries + + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset_global = nperdim*itype; + for (int icoeff = 0; icoeff < size_array_cols-1; icoeff++) { + int irow = irow0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + snap[irow++][icoeff+typeoffset_global] = 0.0; + } + } + + // sum over force on all particles including ghosts + + int nall = atom->nlocal + atom->nghost; + for (int i = 0; i < nall; i++) + for (int itype = 0; itype < atom->ntypes; itype++) { + const int typeoffset_local = ndims_peratom*nperdim*itype; + const int typeoffset_global = nperdim*itype; + double *snadi = snap_peratom[i]+typeoffset_local; + for (int icoeff = 0; icoeff < nperdim; icoeff++) { + double dbdx = snadi[icoeff]; + double dbdy = snadi[icoeff+yoffset]; + double dbdz = snadi[icoeff+zoffset]; + int irow = irow0; + + // RHS is xi*dSum(b_j, j in itype)/dxi + // dSum(bj)/dxi is in first ntypes*3*nperdim elements of row snap_peratom[i] + // LHS is Sum(RHS, i), each row of length ntypes*nperdim + snap[irow++][icoeff+typeoffset_global] += dbdx*x[i][0]; + snap[irow++][icoeff+typeoffset_global] += dbdy*x[i][1]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][2]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][1]; + snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][0]; + snap[irow++][icoeff+typeoffset_global] += dbdy*x[i][0]; + } + } +} + /* ---------------------------------------------------------------------- memory usage ------------------------------------------------------------------------- */ diff --git a/src/SNAP/compute_snap.h b/src/SNAP/compute_snap.h index 970c79c67e..671300faae 100644 --- a/src/SNAP/compute_snap.h +++ b/src/SNAP/compute_snap.h @@ -38,7 +38,7 @@ class ComputeSnap : public Compute { private: int natoms, nmax, size_peratom; int ncoeff, nperdim, yoffset, zoffset; - int virialoffset, ndims_peratom; + int ndims_peratom, ndims_force, ndims_virial; double **cutsq; class NeighList *list; double **snap; @@ -52,6 +52,8 @@ class ComputeSnap : public Compute { Compute *c_pe; Compute *c_virial; + + void dbdotr_compute(); }; } From 7cfd5ce634e48d2704f08a2cecfaffd871f378f7 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 17 Nov 2019 17:01:12 -0700 Subject: [PATCH 475/557] Fixed another problem with typeoffsets --- src/SNAP/compute_snap.cpp | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 904d75a8e3..2a535d5a2b 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -494,13 +494,13 @@ void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) void ComputeSnap::dbdotr_compute() { double **x = atom->x; - int irow0 = 1+ndims_peratom*natoms; + int irow0 = 1+ndims_force*natoms; // zero virial entries for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_global = nperdim*itype; - for (int icoeff = 0; icoeff < size_array_cols-1; icoeff++) { + for (int icoeff = 0; icoeff < nperdim; icoeff++) { int irow = irow0; snap[irow++][icoeff+typeoffset_global] = 0.0; snap[irow++][icoeff+typeoffset_global] = 0.0; From c504d93e3ce583f42698538b12939722579955fd Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Sun, 17 Nov 2019 19:23:14 -0700 Subject: [PATCH 476/557] Found an error in energy row that only affected ntypes > 1 --- src/SNAP/compute_snap.cpp | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 2a535d5a2b..2442e33641 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -387,17 +387,17 @@ void ComputeSnap::compute_array() // linear contributions for (int icoeff = 0; icoeff < ncoeff; icoeff++) - snap[0][icoeff] += snaptr->blist[icoeff]; + snap[0][icoeff+typeoffset_global] += snaptr->blist[icoeff]; // quadratic contributions if (quadraticflag) { for (int icoeff = 0; icoeff < ncoeff; icoeff++) { double bveci = snaptr->blist[icoeff]; - snap[0][icoeff] += 0.5*bveci*bveci; + snap[0][icoeff+typeoffset_global] += 0.5*bveci*bveci; for (int jcoeff = icoeff+1; jcoeff < ncoeff; jcoeff++) { double bvecj = snaptr->blist[jcoeff]; - snap[0][icoeff] += bveci*bvecj; + snap[0][icoeff+typeoffset_global] += bveci*bvecj; } } } From 2e24d0ab265c762c25bca80057e3b2b9cc11c505 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Mon, 18 Nov 2019 10:38:42 -0500 Subject: [PATCH 477/557] step version strings for next patch release --- doc/lammps.1 | 2 +- src/version.h | 2 +- 2 files changed, 2 insertions(+), 2 deletions(-) diff --git a/doc/lammps.1 b/doc/lammps.1 index ec31d19b74..a5045be5c4 100644 --- a/doc/lammps.1 +++ b/doc/lammps.1 @@ -1,4 +1,4 @@ -.TH LAMMPS "30 October 2019" "2019-10-30" +.TH LAMMPS "20 November 2019" "2019-11-20" .SH NAME .B LAMMPS \- Molecular Dynamics Simulator. diff --git a/src/version.h b/src/version.h index 9471c2b951..38ec3883bf 100644 --- a/src/version.h +++ b/src/version.h @@ -1 +1 @@ -#define LAMMPS_VERSION "30 Oct 2019" +#define LAMMPS_VERSION "20 Nov 2019" From 11961084ce8089b9f75f84aba7e011b4c485e6dc Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 18 Nov 2019 21:35:32 -0700 Subject: [PATCH 478/557] Made compute snap fully parallel --- examples/snap/in.snap.compute | 94 +++++++++++++++++++++++ src/SNAP/compute_snap.cpp | 140 +++++++++++++--------------------- src/SNAP/compute_snap.h | 6 +- 3 files changed, 147 insertions(+), 93 deletions(-) create mode 100644 examples/snap/in.snap.compute diff --git a/examples/snap/in.snap.compute b/examples/snap/in.snap.compute new file mode 100644 index 0000000000..9d0739f327 --- /dev/null +++ b/examples/snap/in.snap.compute @@ -0,0 +1,94 @@ +# Demonstrate bispectrum computes + +# Initialize simulation + +variable nsteps index 0 +variable nrep equal 1 +#variable a equal 3.316 +variable a equal 2.0 +units metal + +# generate the box and atom positions using a BCC lattice + +variable nx equal ${nrep} +variable ny equal ${nrep} +variable nz equal ${nrep} + +boundary p p p + +lattice bcc $a +region box block 0 ${nx} 0 ${ny} 0 ${nz} +create_box 2 box +create_atoms 2 box + +mass * 180.88 + +displace_atoms all random 0.1 0.1 0.1 123456 + +# choose SNA parameters + +variable twojmax equal 2 +variable rcutfac equal 1.0 +variable rfac0 equal 0.99363 +variable rmin0 equal 0 +variable radelem1 equal 2.3 +variable radelem2 equal 2.0 +variable wj1 equal 1.0 +variable wj2 equal 0.96 + + +# Setup dummy potential to satisfy cutoff + +pair_style zero ${rcutfac} +pair_coeff * * + +# Setup reference potential + +variable zblcutinner equal 4 +variable zblcutouter equal 4.8 +variable zblz equal 73 +pair_style zbl ${zblcutinner} ${zblcutouter} +pair_coeff * * ${zblz} ${zblz} + +# set up old-style per-atom computes + +compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 +compute vb all snav/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 +compute db all snad/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 + +# perform sums over atoms + +group snapgroup1 type 1 +group snapgroup2 type 2 +compute bsum1 snapgroup1 reduce sum c_b[*] +compute bsum2 snapgroup2 reduce sum c_b[*] +# fix bsum1 all ave/time 1 1 1 c_bsum1 file bsum1.dat mode vector +# fix bsum2 all ave/time 1 1 1 c_bsum2 file bsum2.dat mode vector +compute vbsum all reduce sum c_vb[*] +# fix vbsum all ave/time 1 1 1 c_vbsum file vbsum.dat mode vector + +# set up new-style global compute + +compute snap all snap ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 +compute snap_press all pressure NULL virial +fix snap all ave/time 1 1 1 c_snap[*] file compute.snap.dat mode vector + +thermo 100 + +# test output: 1: total potential energy +# 2: xy component of stress tensor +# 3: Sum(B_{000}^i, all i of type 2) +# 4: xy component of Sum(Sum(r_j*dB_{222}^i/dr_j), all i of type 2), all j) +# followed by counterparts from compute snap + +thermo_style custom & + pe pxy c_bsum2[1] c_vbsum[60] & + c_snap[1][11] c_snap[13][11] c_snap[1][6] c_snap[13][10] +thermo_modify norm no + +# dump mydump_db all custom 1000 dump_db id c_db[*] +# dump_modify mydump_db sort id + +# Run MD + +run ${nsteps} diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 2442e33641..72fce3b01b 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -45,7 +45,7 @@ enum{SCALAR,VECTOR,ARRAY}; ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : Compute(lmp, narg, arg), cutsq(NULL), list(NULL), snap(NULL), - radelem(NULL), wjelem(NULL), snap_peratom(NULL) + radelem(NULL), wjelem(NULL), snap_peratom(NULL), snapall(NULL) { array_flag = 1; @@ -136,9 +136,10 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : natoms = atom->natoms; size_array_rows = 1+ndims_force*natoms+ndims_virial; size_array_cols = nperdim*atom->ntypes+1; + lastcol = size_array_cols-1; + ndims_peratom = ndims_force; size_peratom = ndims_peratom*nperdim*atom->ntypes; - comm_reverse = size_peratom; nmax = 0; } @@ -148,6 +149,7 @@ ComputeSnap::ComputeSnap(LAMMPS *lmp, int narg, char **arg) : ComputeSnap::~ComputeSnap() { memory->destroy(snap); + memory->destroy(snapall); memory->destroy(snap_peratom); memory->destroy(radelem); memory->destroy(wjelem); @@ -185,7 +187,9 @@ void ComputeSnap::init() memory->create(snap,size_array_rows,size_array_cols, "snap:snap"); - array = snap; + memory->create(snapall,size_array_rows,size_array_cols, + "snap:snapall"); + array = snapall; // INCOMPLETE: modify->find_compute() // was called 223960 times by snappy Ta example @@ -235,10 +239,10 @@ void ComputeSnap::compute_array() } // clear global array - // only need to zero out first row of bispectrum - for (int icoeff = 0; icoeff < size_array_cols-1; icoeff++) - snap[0][icoeff] = 0.0; + for (int irow = 0; irow < size_array_rows; irow++) + for (int icoeff = 0; icoeff < size_array_cols; icoeff++) + snap[irow][icoeff] = 0.0; // clear local peratom array @@ -318,7 +322,7 @@ void ComputeSnap::compute_array() snaptr->rcutij[jj],jj); snaptr->compute_dbidrj(); - // Accumulate -dBi/dRi, -dBi/dRj + // Accumulate dBi/dRi, -dBi/dRj double *snadi = snap_peratom[i]+typeoffset_local; double *snadj = snap_peratom[j]+typeoffset_local; @@ -404,91 +408,65 @@ void ComputeSnap::compute_array() } } - // accumulate virial contributions before reverse compute - - dbdotr_compute(); - - // communicate local peratom contributions between neighbor procs - - comm->reverse_comm_compute(this); - - // copy peratom data to global array - // INCOMPLETE ignore local-global mapping for now + // accumulate bispectrum force contributions to global array for (int itype = 0; itype < atom->ntypes; itype++) { const int typeoffset_local = ndims_peratom*nperdim*itype; const int typeoffset_global = nperdim*itype; for (int icoeff = 0; icoeff < nperdim; icoeff++) { int irow = 1; - for (int i = 0; i < atom->nlocal; i++) { + for (int i = 0; i < ntotal; i++) { double *snadi = snap_peratom[i]+typeoffset_local; - snap[irow++][icoeff+typeoffset_global] = snadi[icoeff]; - snap[irow++][icoeff+typeoffset_global] = snadi[icoeff+yoffset]; - snap[irow++][icoeff+typeoffset_global] = snadi[icoeff+zoffset]; + int iglobal = atom->tag[i]; + int irow = 3*(iglobal-1)+1; + snap[irow][icoeff+typeoffset_global] += snadi[icoeff]; + snap[irow+1][icoeff+typeoffset_global] += snadi[icoeff+yoffset]; + snap[irow+2][icoeff+typeoffset_global] += snadi[icoeff+zoffset]; } } } - // assign energy to last column - - int icol = size_array_cols-1; - int irow = 0; - double reference_energy = c_pe->compute_scalar(); - snap[irow++][icol] = reference_energy; - - // assign forces to last column - // INCOMPLETE ignore local-global mapping for now + // accumulate forces to global array for (int i = 0; i < atom->nlocal; i++) { - snap[irow++][icol] = atom->f[i][0]; - snap[irow++][icol] = atom->f[i][1]; - snap[irow++][icol] = atom->f[i][2]; + int iglobal = atom->tag[i]; + int irow = 3*(iglobal-1)+1; + snap[irow][lastcol] = atom->f[i][0]; + snap[irow+1][lastcol] = atom->f[i][1]; + snap[irow+2][lastcol] = atom->f[i][2]; } + // accumulate bispectrum virial contributions to global array + + dbdotr_compute(); + + // sum up over all processes + + MPI_Allreduce(&snap[0][0],&snapall[0][0],size_array_rows*size_array_cols,MPI_DOUBLE,MPI_SUM,world); + + // assign energy to last column + + int irow = 0; + double reference_energy = c_pe->compute_scalar(); + snapall[irow++][lastcol] = reference_energy; + // assign virial stress to last column // switch to Voigt notation c_virial->compute_vector(); - snap[irow++][icol] = c_virial->vector[0]; - snap[irow++][icol] = c_virial->vector[1]; - snap[irow++][icol] = c_virial->vector[2]; - snap[irow++][icol] = c_virial->vector[5]; - snap[irow++][icol] = c_virial->vector[4]; - snap[irow++][icol] = c_virial->vector[3]; + irow += 3*natoms; + snapall[irow++][lastcol] = c_virial->vector[0]; + snapall[irow++][lastcol] = c_virial->vector[1]; + snapall[irow++][lastcol] = c_virial->vector[2]; + snapall[irow++][lastcol] = c_virial->vector[5]; + snapall[irow++][lastcol] = c_virial->vector[4]; + snapall[irow++][lastcol] = c_virial->vector[3]; } -/* ---------------------------------------------------------------------- */ - -int ComputeSnap::pack_reverse_comm(int n, int first, double *buf) -{ - int i,m,last,icoeff; - - m = 0; - last = first + n; - for (i = first; i < last; i++) - for (icoeff = 0; icoeff < size_peratom; icoeff++) - buf[m++] = snap_peratom[i][icoeff]; - return m; -} - -/* ---------------------------------------------------------------------- */ - -void ComputeSnap::unpack_reverse_comm(int n, int *list, double *buf) -{ - int i,j,m,icoeff; - - m = 0; - for (i = 0; i < n; i++) { - j = list[i]; - for (icoeff = 0; icoeff < size_peratom; icoeff++) - snap_peratom[j][icoeff] += buf[m++]; - } -} - /* ---------------------------------------------------------------------- - compute global virial contributions via summing dB dot r over - own & ghost atoms, before reverse comm. + compute global virial contributions via summing r_i.dB^j/dr_i over + own & ghost atoms ------------------------------------------------------------------------- */ void ComputeSnap::dbdotr_compute() @@ -496,22 +474,8 @@ void ComputeSnap::dbdotr_compute() double **x = atom->x; int irow0 = 1+ndims_force*natoms; - // zero virial entries - - for (int itype = 0; itype < atom->ntypes; itype++) { - const int typeoffset_global = nperdim*itype; - for (int icoeff = 0; icoeff < nperdim; icoeff++) { - int irow = irow0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - snap[irow++][icoeff+typeoffset_global] = 0.0; - } - } - - // sum over force on all particles including ghosts + // sum over bispectrum contributions to forces + // on all particles including ghosts int nall = atom->nlocal + atom->nghost; for (int i = 0; i < nall; i++) @@ -524,10 +488,6 @@ void ComputeSnap::dbdotr_compute() double dbdy = snadi[icoeff+yoffset]; double dbdz = snadi[icoeff+zoffset]; int irow = irow0; - - // RHS is xi*dSum(b_j, j in itype)/dxi - // dSum(bj)/dxi is in first ntypes*3*nperdim elements of row snap_peratom[i] - // LHS is Sum(RHS, i), each row of length ntypes*nperdim snap[irow++][icoeff+typeoffset_global] += dbdx*x[i][0]; snap[irow++][icoeff+typeoffset_global] += dbdy*x[i][1]; snap[irow++][icoeff+typeoffset_global] += dbdz*x[i][2]; @@ -547,6 +507,8 @@ double ComputeSnap::memory_usage() double bytes = size_array_rows*size_array_cols * sizeof(double); // snap + bytes += size_array_rows*size_array_cols * + sizeof(double); // snapall bytes += nmax*size_peratom * sizeof(double); // snap_peratom bytes += snaptr->memory_usage(); // SNA object diff --git a/src/SNAP/compute_snap.h b/src/SNAP/compute_snap.h index 671300faae..4f30b7c507 100644 --- a/src/SNAP/compute_snap.h +++ b/src/SNAP/compute_snap.h @@ -31,17 +31,15 @@ class ComputeSnap : public Compute { void init(); void init_list(int, class NeighList *); void compute_array(); - int pack_reverse_comm(int, int, double *); - void unpack_reverse_comm(int, int *, double *); double memory_usage(); private: - int natoms, nmax, size_peratom; + int natoms, nmax, size_peratom, lastcol; int ncoeff, nperdim, yoffset, zoffset; int ndims_peratom, ndims_force, ndims_virial; double **cutsq; class NeighList *list; - double **snap; + double **snap, **snapall; double **snap_peratom; double rcutfac; double *radelem; From 59af51ca91e0f4c1d8a56199380d47e44ff0f33a Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Mon, 18 Nov 2019 23:51:08 -0700 Subject: [PATCH 479/557] Added code to create pressure compute snap_press behind the scenes --- examples/snap/in.snap.compute | 1 - src/SNAP/compute_snap.cpp | 11 +++++++++++ 2 files changed, 11 insertions(+), 1 deletion(-) diff --git a/examples/snap/in.snap.compute b/examples/snap/in.snap.compute index 9d0739f327..f6038ff37a 100644 --- a/examples/snap/in.snap.compute +++ b/examples/snap/in.snap.compute @@ -70,7 +70,6 @@ compute vbsum all reduce sum c_vb[*] # set up new-style global compute compute snap all snap ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 -compute snap_press all pressure NULL virial fix snap all ave/time 1 1 1 c_snap[*] file compute.snap.dat mode vector thermo 100 diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 72fce3b01b..80f731dcf3 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -207,10 +207,21 @@ void ComputeSnap::init() // add compute for reference virial tensor char *id_virial = (char *) "snap_press"; + + char **newarg = new char*[5]; + newarg[0] = id_virial; + newarg[1] = (char *) "all"; + newarg[2] = (char *) "pressure"; + newarg[3] = (char *) "NULL"; + newarg[4] = (char *) "virial"; + modify->add_compute(5,newarg); + delete [] newarg; + int ivirial = modify->find_compute(id_virial); if (ivirial == -1) error->all(FLERR,"compute snap requires that compute snap_press exists."); c_virial = modify->compute[ivirial]; + } From b092a9fffa2d5dc88adf8250453cdbda1b036235 Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 Nov 2019 00:00:04 -0700 Subject: [PATCH 480/557] Added code to create pressure compute snap_press behind the scenes --- src/SNAP/compute_snap.cpp | 3 +-- 1 file changed, 1 insertion(+), 2 deletions(-) diff --git a/src/SNAP/compute_snap.cpp b/src/SNAP/compute_snap.cpp index 80f731dcf3..1a34c8cbc5 100644 --- a/src/SNAP/compute_snap.cpp +++ b/src/SNAP/compute_snap.cpp @@ -207,7 +207,6 @@ void ComputeSnap::init() // add compute for reference virial tensor char *id_virial = (char *) "snap_press"; - char **newarg = new char*[5]; newarg[0] = id_virial; newarg[1] = (char *) "all"; @@ -219,7 +218,7 @@ void ComputeSnap::init() int ivirial = modify->find_compute(id_virial); if (ivirial == -1) - error->all(FLERR,"compute snap requires that compute snap_press exists."); + error->all(FLERR,"compute snap_press does not exist."); c_virial = modify->compute[ivirial]; } From 921d0794bbc00b7058286037acb59445d3fdaa3d Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 Nov 2019 00:12:57 -0700 Subject: [PATCH 481/557] Finished documentation and example --- doc/txt/compute_sna_atom.txt | 52 ++++++++++++++++++++++++++++++++--- examples/snap/in.snap.compute | 21 +++++++------- 2 files changed, 59 insertions(+), 14 deletions(-) diff --git a/doc/txt/compute_sna_atom.txt b/doc/txt/compute_sna_atom.txt index eab32d8757..0639116b93 100644 --- a/doc/txt/compute_sna_atom.txt +++ b/doc/txt/compute_sna_atom.txt @@ -9,12 +9,14 @@ compute sna/atom command :h3 compute snad/atom command :h3 compute snav/atom command :h3 +compute snap command :h3 [Syntax:] compute ID group-ID sna/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... compute ID group-ID snad/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... -compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... :pre +compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... +compute ID group-ID snap rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... :pre ID, group-ID are documented in "compute"_compute.html command :ulb,l sna/atom = style name of this compute command :l @@ -41,12 +43,17 @@ keyword = {rmin0} or {switchflag} or {bzeroflag} or {quadraticflag} :l compute b all sna/atom 1.4 0.99363 6 2.0 2.4 0.75 1.0 rmin0 0.0 compute db all sna/atom 1.4 0.95 6 2.0 1.0 -compute vb all sna/atom 1.4 0.95 6 2.0 1.0 :pre +compute vb all sna/atom 1.4 0.95 6 2.0 1.0 +compute snap all snap 1.4 0.95 6 2.0 1.0 :pre [Description:] -Define a computation that calculates a set of bispectrum components -for each atom in a group. +Define a computation that calculates a set of quantities related to the +bispectrum components of the atoms in a group. These computes are +used primarily for calculating the dependence of energy, force, and +stress components on the linear coefficients in the +"snap pair_style"_pair_snap.html, which is useful when training a +SNAP potential to match target data. Bispectrum components of an atom are order parameters characterizing the radial and angular distribution of neighbor atoms. The detailed @@ -130,6 +137,26 @@ Again, the sum is over all atoms {i'} of atom type {I}. For each atom virial components, each atom type, and each bispectrum component. See section below on output for a detailed explanation. +Compute {snap} calculates a global array contains information related +to all three of the preceding per-atom computes {sna/atom}, {snad/atom}, +and {snav/atom}. The first row of the array contains the summation of +{sna/atom} over all atoms, but broken out by type. The last six rows +of the array contain the summation of {snav/atom} over all atoms, broken +out by type. In between these are 3*N rows containing the same values +computed by {snad/atom} (these are already summed over all atoms and +broken out by type). The element in the last column of each row contains +the corresponding contribution to potential energy, force, or stress. +These quantities correspond to the user-specified refence potential +that must be subtracted from the target data when fitting SNAP. +The potential energy calculation uses the built in compute {thermo_pe}. +The stess calculation requires that a compute called {snap_press} +be defined using the following command: + +compute snap_press all pressure NULL virial :pre + +See section below on output for a detailed explanation of the data +layout in the global array. + The value of all bispectrum components will be zero for atoms not in the group. Neighbor atoms not in the group do not contribute to the bispectrum of atoms in the group. @@ -214,10 +241,27 @@ block contains six sub-blocks corresponding to the {xx}, {yy}, {zz}, notation. Each of these sub-blocks contains one column for each bispectrum component, the same as for compute {sna/atom} +Compute {snap} evaluates a global array. +The columns are arranged into +{ntypes} blocks, listed in order of atom type {I}. Each block +contains one column for each bispectrum component, the same as for compute +{sna/atom}. A final column contains the corresponding energy, force component +on an atom, and virial stress component. The rows of the array appear +in the following order: + + 1 row: {sna/atom} quantities summed for all atoms of type {I} + 3*N rows: {snad/atom} quantities, with derivatives w.r.t x, y, and z +coordinate of atom {i} appearing in consecutive rows. The atoms +are sorted based on atom ID. + 6 rows: {snav/atom} quantities summed for all atoms of type {I} :ul + For example, if {K} =30 and ntypes=1, the number of columns in the per-atom arrays generated by {sna/atom}, {snad/atom}, and {snav/atom} are 30, 90, and 180, respectively. With {quadratic} value=1, the numbers of columns are 930, 2790, and 5580, respectively. +The number of columns in the global array generated by {snap} +are 31, and 931, respectively, while the number of rows is +1+3*{N} +6, where {N} is the total number of atoms. If the {quadratic} keyword value is set to 1, then additional columns are generated, corresponding to diff --git a/examples/snap/in.snap.compute b/examples/snap/in.snap.compute index f6038ff37a..8955500e0e 100644 --- a/examples/snap/in.snap.compute +++ b/examples/snap/in.snap.compute @@ -1,6 +1,6 @@ # Demonstrate bispectrum computes -# Initialize simulation +# initialize simulation variable nsteps index 0 variable nrep equal 1 @@ -35,14 +35,15 @@ variable radelem1 equal 2.3 variable radelem2 equal 2.0 variable wj1 equal 1.0 variable wj2 equal 0.96 +variable snap_options string & +"${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0" - -# Setup dummy potential to satisfy cutoff +# set up dummy potential to satisfy cutoff pair_style zero ${rcutfac} pair_coeff * * -# Setup reference potential +# set up reference potential variable zblcutinner equal 4 variable zblcutouter equal 4.8 @@ -50,11 +51,11 @@ variable zblz equal 73 pair_style zbl ${zblcutinner} ${zblcutouter} pair_coeff * * ${zblz} ${zblz} -# set up old-style per-atom computes +# set up per-atom computes -compute b all sna/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 -compute vb all snav/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 -compute db all snad/atom ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 +compute b all sna/atom ${snap_options} +compute vb all snav/atom ${snap_options} +compute db all snad/atom ${snap_options} # perform sums over atoms @@ -67,9 +68,9 @@ compute bsum2 snapgroup2 reduce sum c_b[*] compute vbsum all reduce sum c_vb[*] # fix vbsum all ave/time 1 1 1 c_vbsum file vbsum.dat mode vector -# set up new-style global compute +# set up compute snap generating global array -compute snap all snap ${rcutfac} ${rfac0} ${twojmax} ${radelem1} ${radelem2} ${wj1} ${wj2} rmin0 ${rmin0} quadraticflag 0 bzeroflag 0 switchflag 0 +compute snap all snap ${snap_options} fix snap all ave/time 1 1 1 c_snap[*] file compute.snap.dat mode vector thermo 100 From 920a217ee19710cffc2cacb23b016588bb2d091b Mon Sep 17 00:00:00 2001 From: "Aidan P. Thompson" Date: Tue, 19 Nov 2019 00:47:29 -0700 Subject: [PATCH 482/557] Fixed some formatting issues --- doc/src/compute_sna_atom.rst | 54 ++++++++++++++++++++++++++++++++++-- doc/txt/compute_sna_atom.txt | 19 ++++++------- 2 files changed, 60 insertions(+), 13 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 882fdbb0a0..1119c21996 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -9,6 +9,9 @@ compute snad/atom command compute snav/atom command ========================= +compute snap command +==================== + Syntax """""" @@ -17,7 +20,8 @@ Syntax compute ID group-ID sna/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... compute ID group-ID snad/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... - compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID snap rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... * ID, group-ID are documented in :doc:`compute ` command * sna/atom = style name of this compute command @@ -53,12 +57,17 @@ Examples compute b all sna/atom 1.4 0.99363 6 2.0 2.4 0.75 1.0 rmin0 0.0 compute db all sna/atom 1.4 0.95 6 2.0 1.0 compute vb all sna/atom 1.4 0.95 6 2.0 1.0 + compute snap all snap 1.4 0.95 6 2.0 1.0 Description """"""""""" -Define a computation that calculates a set of bispectrum components -for each atom in a group. +Define a computation that calculates a set of quantities related to the +bispectrum components of the atoms in a group. These computes are +used primarily for calculating the dependence of energy, force, and +stress components on the linear coefficients in the +:doc:`snap pair\_style `, which is useful when training a +SNAP potential to match target data. Bispectrum components of an atom are order parameters characterizing the radial and angular distribution of neighbor atoms. The detailed @@ -148,6 +157,30 @@ Again, the sum is over all atoms *i'* of atom type *I*\ . For each atom virial components, each atom type, and each bispectrum component. See section below on output for a detailed explanation. +Compute *snap* calculates a global array contains information related +to all three of the above per-atom computes *sna/atom*\ , *snad/atom*\ , +and *snav/atom*\ . The first row of the array contains the summation of +*sna/atom* over all atoms, but broken out by type. The last six rows +of the array contain the summation of *snav/atom* over all atoms, broken +out by type. In between these are 3\*\ *N* rows containing the same values +computed by *snad/atom* (these are already summed over all atoms and +broken out by type). The element in the last column of each row contains +the potential energy, force, or stress, according to the row. +These quantities correspond to the user-specified refence potential +that must be subtracted from the target data when fitting SNAP. +The potential energy calculation uses the built in compute *thermo\_pe*. +The stress calculation uses a compute called *snap\_press* that is +automatically created behind the scenes, according to the following +command: + + +.. parsed-literal:: + + compute snap_press all pressure NULL virial + +See section below on output for a detailed explanation of the data +layout in the global array. + The value of all bispectrum components will be zero for atoms not in the group. Neighbor atoms not in the group do not contribute to the bispectrum of atoms in the group. @@ -239,10 +272,25 @@ block contains six sub-blocks corresponding to the *xx*\ , *yy*\ , *zz*\ , notation. Each of these sub-blocks contains one column for each bispectrum component, the same as for compute *sna/atom* +Compute *snap* evaluates a global array. +The columns are arranged into +*ntypes* blocks, listed in order of atom type *I*\ . Each block +contains one column for each bispectrum component, the same as for compute +*sna/atom*\ . A final column contains the corresponding energy, force component +on an atom, or virial stress component. The rows of the array appear +in the following order: + +* 1 row: *sna/atom* quantities summed for all atoms of type *I* +* 3\*\ *N* rows: *snad/atom* quantities, with derivatives w.r.t. x, y, and z coordinate of atom *i* appearing in consecutive rows. The atoms are sorted based on atom ID. +* 6 rows: *snav/atom* quantities summed for all atoms of type *I* + For example, if *K* =30 and ntypes=1, the number of columns in the per-atom arrays generated by *sna/atom*\ , *snad/atom*\ , and *snav/atom* are 30, 90, and 180, respectively. With *quadratic* value=1, the numbers of columns are 930, 2790, and 5580, respectively. +The number of columns in the global array generated by *snap* +are 31, and 931, respectively, while the number of rows is +1+3\*\ *N*\ +6, where *N* is the total number of atoms. If the *quadratic* keyword value is set to 1, then additional columns are generated, corresponding to diff --git a/doc/txt/compute_sna_atom.txt b/doc/txt/compute_sna_atom.txt index 0639116b93..05a0bee923 100644 --- a/doc/txt/compute_sna_atom.txt +++ b/doc/txt/compute_sna_atom.txt @@ -138,19 +138,20 @@ virial components, each atom type, and each bispectrum component. See section below on output for a detailed explanation. Compute {snap} calculates a global array contains information related -to all three of the preceding per-atom computes {sna/atom}, {snad/atom}, +to all three of the above per-atom computes {sna/atom}, {snad/atom}, and {snav/atom}. The first row of the array contains the summation of {sna/atom} over all atoms, but broken out by type. The last six rows of the array contain the summation of {snav/atom} over all atoms, broken -out by type. In between these are 3*N rows containing the same values +out by type. In between these are 3*{N} rows containing the same values computed by {snad/atom} (these are already summed over all atoms and broken out by type). The element in the last column of each row contains -the corresponding contribution to potential energy, force, or stress. +the potential energy, force, or stress, according to the row. These quantities correspond to the user-specified refence potential that must be subtracted from the target data when fitting SNAP. The potential energy calculation uses the built in compute {thermo_pe}. -The stess calculation requires that a compute called {snap_press} -be defined using the following command: +The stress calculation uses a compute called {snap_press} that is +automatically created behind the scenes, according to the following +command: compute snap_press all pressure NULL virial :pre @@ -246,13 +247,11 @@ The columns are arranged into {ntypes} blocks, listed in order of atom type {I}. Each block contains one column for each bispectrum component, the same as for compute {sna/atom}. A final column contains the corresponding energy, force component -on an atom, and virial stress component. The rows of the array appear +on an atom, or virial stress component. The rows of the array appear in the following order: 1 row: {sna/atom} quantities summed for all atoms of type {I} - 3*N rows: {snad/atom} quantities, with derivatives w.r.t x, y, and z -coordinate of atom {i} appearing in consecutive rows. The atoms -are sorted based on atom ID. + 3*{N} rows: {snad/atom} quantities, with derivatives w.r.t. x, y, and z coordinate of atom {i} appearing in consecutive rows. The atoms are sorted based on atom ID. 6 rows: {snav/atom} quantities summed for all atoms of type {I} :ul For example, if {K} =30 and ntypes=1, the number of columns in the per-atom @@ -261,7 +260,7 @@ are 30, 90, and 180, respectively. With {quadratic} value=1, the numbers of columns are 930, 2790, and 5580, respectively. The number of columns in the global array generated by {snap} are 31, and 931, respectively, while the number of rows is -1+3*{N} +6, where {N} is the total number of atoms. +1+3*{N}+6, where {N} is the total number of atoms. If the {quadratic} keyword value is set to 1, then additional columns are generated, corresponding to From 897ffef242e513a3a42e9faac4279e380377cdea Mon Sep 17 00:00:00 2001 From: Aidan Thompson Date: Tue, 19 Nov 2019 00:50:57 -0700 Subject: [PATCH 483/557] Fixed some formatting issues --- doc/src/compute_sna_atom.rst | 54 ++++++++++++++++++++++++++++++++++-- doc/txt/compute_sna_atom.txt | 19 ++++++------- 2 files changed, 60 insertions(+), 13 deletions(-) diff --git a/doc/src/compute_sna_atom.rst b/doc/src/compute_sna_atom.rst index 882fdbb0a0..1119c21996 100644 --- a/doc/src/compute_sna_atom.rst +++ b/doc/src/compute_sna_atom.rst @@ -9,6 +9,9 @@ compute snad/atom command compute snav/atom command ========================= +compute snap command +==================== + Syntax """""" @@ -17,7 +20,8 @@ Syntax compute ID group-ID sna/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... compute ID group-ID snad/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... - compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID snav/atom rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... + compute ID group-ID snap rcutfac rfac0 twojmax R_1 R_2 ... w_1 w_2 ... keyword values ... * ID, group-ID are documented in :doc:`compute ` command * sna/atom = style name of this compute command @@ -53,12 +57,17 @@ Examples compute b all sna/atom 1.4 0.99363 6 2.0 2.4 0.75 1.0 rmin0 0.0 compute db all sna/atom 1.4 0.95 6 2.0 1.0 compute vb all sna/atom 1.4 0.95 6 2.0 1.0 + compute snap all snap 1.4 0.95 6 2.0 1.0 Description """"""""""" -Define a computation that calculates a set of bispectrum components -for each atom in a group. +Define a computation that calculates a set of quantities related to the +bispectrum components of the atoms in a group. These computes are +used primarily for calculating the dependence of energy, force, and +stress components on the linear coefficients in the +:doc:`snap pair\_style `, which is useful when training a +SNAP potential to match target data. Bispectrum components of an atom are order parameters characterizing the radial and angular distribution of neighbor atoms. The detailed @@ -148,6 +157,30 @@ Again, the sum is over all atoms *i'* of atom type *I*\ . For each atom virial components, each atom type, and each bispectrum component. See section below on output for a detailed explanation. +Compute *snap* calculates a global array contains information related +to all three of the above per-atom computes *sna/atom*\ , *snad/atom*\ , +and *snav/atom*\ . The first row of the array contains the summation of +*sna/atom* over all atoms, but broken out by type. The last six rows +of the array contain the summation of *snav/atom* over all atoms, broken +out by type. In between these are 3\*\ *N* rows containing the same values +computed by *snad/atom* (these are already summed over all atoms and +broken out by type). The element in the last column of each row contains +the potential energy, force, or stress, according to the row. +These quantities correspond to the user-specified refence potential +that must be subtracted from the target data when fitting SNAP. +The potential energy calculation uses the built in compute *thermo\_pe*. +The stress calculation uses a compute called *snap\_press* that is +automatically created behind the scenes, according to the following +command: + + +.. parsed-literal:: + + compute snap_press all pressure NULL virial + +See section below on output for a detailed explanation of the data +layout in the global array. + The value of all bispectrum components will be zero for atoms not in the group. Neighbor atoms not in the group do not contribute to the bispectrum of atoms in the group. @@ -239,10 +272,25 @@ block contains six sub-blocks corresponding to the *xx*\ , *yy*\ , *zz*\ , notation. Each of these sub-blocks contains one column for each bispectrum component, the same as for compute *sna/atom* +Compute *snap* evaluates a global array. +The columns are arranged into +*ntypes* blocks, listed in order of atom type *I*\ . Each block +contains one column for each bispectrum component, the same as for compute +*sna/atom*\ . A final column contains the corresponding energy, force component +on an atom, or virial stress component. The rows of the array appear +in the following order: + +* 1 row: *sna/atom* quantities summed for all atoms of type *I* +* 3\*\ *N* rows: *snad/atom* quantities, with derivatives w.r.t. x, y, and z coordinate of atom *i* appearing in consecutive rows. The atoms are sorted based on atom ID. +* 6 rows: *snav/atom* quantities summed for all atoms of type *I* + For example, if *K* =30 and ntypes=1, the number of columns in the per-atom arrays generated by *sna/atom*\ , *snad/atom*\ , and *snav/atom* are 30, 90, and 180, respectively. With *quadratic* value=1, the numbers of columns are 930, 2790, and 5580, respectively. +The number of columns in the global array generated by *snap* +are 31, and 931, respectively, while the number of rows is +1+3\*\ *N*\ +6, where *N* is the total number of atoms. If the *quadratic* keyword value is set to 1, then additional columns are generated, corresponding to diff --git a/doc/txt/compute_sna_atom.txt b/doc/txt/compute_sna_atom.txt index 0639116b93..05a0bee923 100644 --- a/doc/txt/compute_sna_atom.txt +++ b/doc/txt/compute_sna_atom.txt @@ -138,19 +138,20 @@ virial components, each atom type, and each bispectrum component. See section below on output for a detailed explanation. Compute {snap} calculates a global array contains information related -to all three of the preceding per-atom computes {sna/atom}, {snad/atom}, +to all three of the above per-atom computes {sna/atom}, {snad/atom}, and {snav/atom}. The first row of the array contains the summation of {sna/atom} over all atoms, but broken out by type. The last six rows of the array contain the summation of {snav/atom} over all atoms, broken -out by type. In between these are 3*N rows containing the same values +out by type. In between these are 3*{N} rows containing the same values computed by {snad/atom} (these are already summed over all atoms and broken out by type). The element in the last column of each row contains -the corresponding contribution to potential energy, force, or stress. +the potential energy, force, or stress, according to the row. These quantities correspond to the user-specified refence potential that must be subtracted from the target data when fitting SNAP. The potential energy calculation uses the built in compute {thermo_pe}. -The stess calculation requires that a compute called {snap_press} -be defined using the following command: +The stress calculation uses a compute called {snap_press} that is +automatically created behind the scenes, according to the following +command: compute snap_press all pressure NULL virial :pre @@ -246,13 +247,11 @@ The columns are arranged into {ntypes} blocks, listed in order of atom type {I}. Each block contains one column for each bispectrum component, the same as for compute {sna/atom}. A final column contains the corresponding energy, force component -on an atom, and virial stress component. The rows of the array appear +on an atom, or virial stress component. The rows of the array appear in the following order: 1 row: {sna/atom} quantities summed for all atoms of type {I} - 3*N rows: {snad/atom} quantities, with derivatives w.r.t x, y, and z -coordinate of atom {i} appearing in consecutive rows. The atoms -are sorted based on atom ID. + 3*{N} rows: {snad/atom} quantities, with derivatives w.r.t. x, y, and z coordinate of atom {i} appearing in consecutive rows. The atoms are sorted based on atom ID. 6 rows: {snav/atom} quantities summed for all atoms of type {I} :ul For example, if {K} =30 and ntypes=1, the number of columns in the per-atom @@ -261,7 +260,7 @@ are 30, 90, and 180, respectively. With {quadratic} value=1, the numbers of columns are 930, 2790, and 5580, respectively. The number of columns in the global array generated by {snap} are 31, and 931, respectively, while the number of rows is -1+3*{N} +6, where {N} is the total number of atoms. +1+3*{N}+6, where {N} is the total number of atoms. If the {quadratic} keyword value is set to 1, then additional columns are generated, corresponding to From 5435d19a7c65fe0bcda07139190ae46237466c85 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 13:48:39 -0500 Subject: [PATCH 484/557] update compute command lists for added compute centroid/stress/atom --- doc/src/Commands_compute.rst | 98 +++++++++---------- doc/src/compute.rst | 1 + doc/txt/Commands_compute.txt | 1 + doc/txt/compute.txt | 1 + doc/txt/compute_stress_atom.txt | 168 -------------------------------- 5 files changed, 52 insertions(+), 217 deletions(-) delete mode 100644 doc/txt/compute_stress_atom.txt diff --git a/doc/src/Commands_compute.rst b/doc/src/Commands_compute.rst index 351eca3709..ab30339035 100644 --- a/doc/src/Commands_compute.rst +++ b/doc/src/Commands_compute.rst @@ -14,55 +14,55 @@ Some styles have accelerated versions. This is indicated by additional letters in parenthesis: g = GPU, i = USER-INTEL, k = KOKKOS, o = USER-OMP, t = OPT. -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`chunk/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | :doc:`com/chunk ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | :doc:`dilatation/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | :doc:`entropy/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | :doc:`fep ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | :doc:`gyration/chunk ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`gyration/shape ` | :doc:`gyration/shape/chunk ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | :doc:`hma ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`improper ` | :doc:`improper/local ` | :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | :doc:`ke/atom/eff ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`ke/eff ` | :doc:`ke/rigid ` | :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | :doc:`momentum ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`msd ` | :doc:`msd/chunk ` | :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | :doc:`pair ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`pair/local ` | :doc:`pe ` | :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | :doc:`plasticity/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`pressure ` | :doc:`pressure/cylinder ` | :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | :doc:`property/local ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`ptm/atom ` | :doc:`rdf ` | :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | :doc:`rigid/local ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`saed ` | :doc:`slice ` | :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | :doc:`smd/internal/energy ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`smd/plastic/strain ` | :doc:`smd/plastic/strain/rate ` | :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | :doc:`smd/tlsph/num/neighs ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`smd/tlsph/shape ` | :doc:`smd/tlsph/strain ` | :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | :doc:`smd/ulsph/num/neighs ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`smd/ulsph/strain ` | :doc:`smd/ulsph/strain/rate ` | :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | :doc:`snad/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`snav/atom ` | :doc:`spin ` | :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | :doc:`stress/tally ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`tdpd/cc/atom ` | :doc:`temp (k) ` | :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | :doc:`temp/com ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`temp/cs ` | :doc:`temp/deform ` | :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | :doc:`temp/partial ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`temp/profile ` | :doc:`temp/ramp ` | :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | :doc:`temp/sphere ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`temp/uef ` | :doc:`ti ` | :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | :doc:`voronoi/atom ` | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ -| :doc:`xrd ` | | | | | | -+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+------------------------------------------------------------+ ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`ackland/atom ` | :doc:`adf ` | :doc:`aggregate/atom ` | :doc:`angle ` | :doc:`angle/local ` | :doc:`angmom/chunk ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`basal/atom ` | :doc:`body/local ` | :doc:`bond ` | :doc:`bond/local ` | :doc:`centro/atom ` | :doc:`centroid/stress/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`chunk/atom ` | :doc:`chunk/spread/atom ` | :doc:`cluster/atom ` | :doc:`cna/atom ` | :doc:`cnp/atom ` | :doc:`com ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`com/chunk ` | :doc:`contact/atom ` | :doc:`coord/atom ` | :doc:`damage/atom ` | :doc:`dihedral ` | :doc:`dihedral/local ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`dilatation/atom ` | :doc:`dipole/chunk ` | :doc:`displace/atom ` | :doc:`dpd ` | :doc:`dpd/atom ` | :doc:`edpd/temp/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`entropy/atom ` | :doc:`erotate/asphere ` | :doc:`erotate/rigid ` | :doc:`erotate/sphere ` | :doc:`erotate/sphere/atom ` | :doc:`event/displace ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`fep ` | :doc:`force/tally ` | :doc:`fragment/atom ` | :doc:`global/atom ` | :doc:`group/group ` | :doc:`gyration ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`gyration/chunk ` | :doc:`gyration/shape ` | :doc:`gyration/shape/chunk ` | :doc:`heat/flux ` | :doc:`heat/flux/tally ` | :doc:`hexorder/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`hma ` | :doc:`improper ` | :doc:`improper/local ` | :doc:`inertia/chunk ` | :doc:`ke ` | :doc:`ke/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`ke/atom/eff ` | :doc:`ke/eff ` | :doc:`ke/rigid ` | :doc:`meso/e/atom ` | :doc:`meso/rho/atom ` | :doc:`meso/t/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`momentum ` | :doc:`msd ` | :doc:`msd/chunk ` | :doc:`msd/nongauss ` | :doc:`omega/chunk ` | :doc:`orientorder/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`pair ` | :doc:`pair/local ` | :doc:`pe ` | :doc:`pe/atom ` | :doc:`pe/mol/tally ` | :doc:`pe/tally ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`plasticity/atom ` | :doc:`pressure ` | :doc:`pressure/cylinder ` | :doc:`pressure/uef ` | :doc:`property/atom ` | :doc:`property/chunk ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`property/local ` | :doc:`ptm/atom ` | :doc:`rdf ` | :doc:`reduce ` | :doc:`reduce/chunk ` | :doc:`reduce/region ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`rigid/local ` | :doc:`saed ` | :doc:`slice ` | :doc:`smd/contact/radius ` | :doc:`smd/damage ` | :doc:`smd/hourglass/error ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`smd/internal/energy ` | :doc:`smd/plastic/strain ` | :doc:`smd/plastic/strain/rate ` | :doc:`smd/rho ` | :doc:`smd/tlsph/defgrad ` | :doc:`smd/tlsph/dt ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`smd/tlsph/num/neighs ` | :doc:`smd/tlsph/shape ` | :doc:`smd/tlsph/strain ` | :doc:`smd/tlsph/strain/rate ` | :doc:`smd/tlsph/stress ` | :doc:`smd/triangle/vertices ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`smd/ulsph/num/neighs ` | :doc:`smd/ulsph/strain ` | :doc:`smd/ulsph/strain/rate ` | :doc:`smd/ulsph/stress ` | :doc:`smd/vol ` | :doc:`sna/atom ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`snad/atom ` | :doc:`snav/atom ` | :doc:`spin ` | :doc:`stress/atom ` | :doc:`stress/mop ` | :doc:`stress/mop/profile ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`stress/tally ` | :doc:`tdpd/cc/atom ` | :doc:`temp (k) ` | :doc:`temp/asphere ` | :doc:`temp/body ` | :doc:`temp/chunk ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`temp/com ` | :doc:`temp/cs ` | :doc:`temp/deform ` | :doc:`temp/deform/eff ` | :doc:`temp/drude ` | :doc:`temp/eff ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`temp/partial ` | :doc:`temp/profile ` | :doc:`temp/ramp ` | :doc:`temp/region ` | :doc:`temp/region/eff ` | :doc:`temp/rotate ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`temp/sphere ` | :doc:`temp/uef ` | :doc:`ti ` | :doc:`torque/chunk ` | :doc:`vacf ` | :doc:`vcm/chunk ` | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ +| :doc:`voronoi/atom ` | :doc:`xrd ` | | | | | ++------------------------------------------------------------+--------------------------------------------------------+------------------------------------------------------------------+--------------------------------------------------------------+----------------------------------------------------------+--------------------------------------------------------------+ .. _lws: http://lammps.sandia.gov diff --git a/doc/src/compute.rst b/doc/src/compute.rst index 419352a9ac..af9c3d6fbc 100644 --- a/doc/src/compute.rst +++ b/doc/src/compute.rst @@ -191,6 +191,7 @@ The individual style names on the :doc:`Commands compute ` doc * :doc:`bond ` - energy of each bond sub-style * :doc:`bond/local ` - distance and energy of each bond * :doc:`centro/atom ` - centro-symmetry parameter for each atom +* :doc:`centroid/stress/atom ` - centroid based stress tensor for each atom * :doc:`chunk/atom ` - assign chunk IDs to each atom * :doc:`chunk/spread/atom ` - spreads chunk values to each atom in chunk * :doc:`cluster/atom ` - cluster ID for each atom diff --git a/doc/txt/Commands_compute.txt b/doc/txt/Commands_compute.txt index 1bff982586..caf627188b 100644 --- a/doc/txt/Commands_compute.txt +++ b/doc/txt/Commands_compute.txt @@ -35,6 +35,7 @@ KOKKOS, o = USER-OMP, t = OPT. "bond"_compute_bond.html, "bond/local"_compute_bond_local.html, "centro/atom"_compute_centro_atom.html, +"centroid/stress/atom"_compute_stress_atom.html, "chunk/atom"_compute_chunk_atom.html, "chunk/spread/atom"_compute_chunk_spread_atom.html, "cluster/atom"_compute_cluster_atom.html, diff --git a/doc/txt/compute.txt b/doc/txt/compute.txt index 2d6d26ff16..eb819e329c 100644 --- a/doc/txt/compute.txt +++ b/doc/txt/compute.txt @@ -182,6 +182,7 @@ compute"_Commands_compute.html doc page are followed by one or more of "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 +"centroid/stress/atom"_compute_stress_atom.html - centroid based stress tensor 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 diff --git a/doc/txt/compute_stress_atom.txt b/doc/txt/compute_stress_atom.txt deleted file mode 100644 index d81d97061c..0000000000 --- a/doc/txt/compute_stress_atom.txt +++ /dev/null @@ -1,168 +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 - -compute stress/atom command :h3 - -[Syntax:] - -compute ID group-ID stress/atom temp-ID keyword ... :pre - -ID, group-ID are documented in "compute"_compute.html command -stress/atom = 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 - -[Examples:] - -compute 1 mobile stress/atom NULL -compute 1 mobile stress/atom myRamp -compute 1 all stress/atom NULL pair bond :pre - -[Description:] - -Define a computation that computes the symmetric per-atom stress -tensor for each atom in a group. The tensor for each atom has 6 -components and is stored as a 6-element vector in the following order: -xx, yy, zz, xy, xz, yz. See the "compute -pressure"_compute_pressure.html command if you want the stress tensor -(pressure) of the entire system. - -The stress tensor for atom {I} is given by the following formula, -where {a} and {b} take on values x,y,z to generate the 6 components of -the symmetric tensor: - -:c,image(Eqs/stress_tensor.jpg) - -The first term is a kinetic energy contribution for atom {I}. See -details below on how the specified {temp-ID} can affect the velocities -used in this calculation. The second term is a pairwise energy -contribution where {n} loops over the {Np} neighbors of atom {I}, {r1} -and {r2} are the positions of the 2 atoms in the pairwise interaction, -and {F1} and {F2} are the forces on the 2 atoms resulting from the -pairwise interaction. The third term is a bond contribution of -similar form for the {Nb} bonds which atom {I} is part of. There are -similar terms for the {Na} angle, {Nd} dihedral, and {Ni} improper -interactions atom {I} is part of. There is also a term for the KSpace -contribution from long-range Coulombic interactions, if defined. -Finally, there is a term for the {Nf} "fixes"_fix.html that apply -internal constraint forces to atom {I}. Currently, only the "fix -shake"_fix_shake.html and "fix rigid"_fix_rigid.html commands -contribute to this term. - -As the coefficients in the formula imply, a virial contribution -produced by a small set of atoms (e.g. 4 atoms in a dihedral or 3 -atoms in a Tersoff 3-body interaction) is assigned in equal portions -to each atom in the set. E.g. 1/4 of the dihedral virial to each of -the 4 atoms, or 1/3 of the fix virial due to SHAKE constraints applied -to atoms in a water molecule via the "fix shake"_fix_shake.html -command. - -If no extra keywords are listed, all of the terms in this formula are -included in the per-atom stress tensor. If any extra keywords are -listed, only those terms are summed to compute the tensor. The -{virial} keyword means include all terms except the kinetic energy -{ke}. - -Note that the stress for each atom is due to its interaction with all -other atoms in the simulation, not just with other atoms in the group. - -Details of how LAMMPS computes the virial for individual atoms for -either pairwise or many-body potentials, and including the effects of -periodic boundary conditions is discussed in "(Thompson)"_#Thompson2. -The basic idea for many-body potentials is to treat each component of -the force computation between a small cluster of atoms in the same -manner as in the formula above for bond, angle, dihedral, etc -interactions. Namely the quantity R dot F is summed over the atoms in -the interaction, with the R vectors unwrapped by periodic boundaries -so that the cluster of atoms is close together. The total -contribution for the cluster interaction is divided evenly among those -atoms. - -The "dihedral_style charmm"_dihedral_charmm.html style calculates -pairwise interactions between 1-4 atoms. The virial contribution of -these terms is included in the pair virial, not the dihedral virial. - -The KSpace contribution is calculated using the method in -"(Heyes)"_#Heyes2 for the Ewald method and by the methodology described -in "(Sirk)"_#Sirk1 for PPPM. The choice of KSpace solver is specified -by the "kspace_style pppm"_kspace_style.html command. Note that for -PPPM, the calculation requires 6 extra FFTs each timestep that -per-atom stress is calculated. Thus it can significantly increase the -cost of the PPPM calculation if it is needed on a large fraction of -the simulation timesteps. - -The {temp-ID} argument can be used to affect the per-atom velocities -used in the kinetic energy contribution to the total stress. If the -kinetic energy is not included in the stress, than the temperature -compute is not used and can be specified as NULL. If the kinetic -energy is included and you wish to use atom velocities as-is, then -{temp-ID} can also be specified as NULL. If desired, the specified -temperature compute can be one that subtracts off a bias to leave each -atom with only a thermal velocity to use in the formula above, e.g. by -subtracting a background streaming velocity. See the doc pages for -individual "compute commands"_compute.html to determine which ones -include a bias. - -:line - -Note that as defined in the formula, per-atom stress is the negative -of the per-atom pressure tensor. It is also really a stress*volume -formulation, meaning the computed quantity is in units of -pressure*volume. It would need to be divided by a per-atom volume to -have units of stress (pressure), but an individual atom's volume is -not well defined or easy to compute in a deformed solid or a liquid. -See the "compute voronoi/atom"_compute_voronoi_atom.html command for -one possible way to estimate a per-atom volume. - -Thus, if the diagonal components of the per-atom stress tensor are -summed for all atoms in the system and the sum is divided by dV, where -d = dimension and V is the volume of the system, the result should be --P, where P is the total pressure of the system. - -These lines in an input script for a 3d system should yield that -result. I.e. the last 2 columns of thermo output will be the same: - -compute peratom all stress/atom NULL -compute p all reduce sum c_peratom\[1\] c_peratom\[2\] c_peratom\[3\] -variable press equal -(c_p\[1\]+c_p\[2\]+c_p\[3\])/(3*vol) -thermo_style custom step temp etotal press v_press :pre - -NOTE: The per-atom stress does not include any Lennard-Jones tail -corrections to the pressure added by the "pair_modify tail -yes"_pair_modify.html command, since those are contributions to the -global system pressure. - -[Output info:] - -This compute calculates a per-atom array with 6 columns, which can be -accessed by indices 1-6 by any command that uses per-atom values from -a compute as input. See the "Howto output"_Howto_output.html doc page -for an overview of LAMMPS output options. - -The per-atom array values will be in pressure*volume -"units"_units.html as discussed above. - -[Restrictions:] none - -[Related commands:] - -"compute pe"_compute_pe.html, "compute pressure"_compute_pressure.html - -[Default:] none - -:line - -:link(Heyes2) -[(Heyes)] Heyes, Phys Rev B 49, 755 (1994), - -:link(Sirk1) -[(Sirk)] Sirk, Moore, Brown, J Chem Phys, 138, 064505 (2013). - -:link(Thompson2) -[(Thompson)] Thompson, Plimpton, Mattson, J Chem Phys, 131, 154107 (2009). From b109fd1687cef27de0f6a6c8053eaa7d51359a01 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 19 Nov 2019 12:50:52 -0700 Subject: [PATCH 485/557] Commit JT 111919 - modified named of tests, from benchmark to validation --- examples/SPIN/read_restart/in.spin.restart | 2 +- examples/SPIN/{benchmark => validation}/README | 0 .../validation_damped_exchange}/bench-spin-precession.in | 0 .../validation_damped_exchange}/llg_exchange.py | 0 .../validation_damped_exchange}/plot_precession.py | 0 .../validation_damped_exchange}/run-bench-exchange.sh | 0 .../validation_damped_exchange}/two_spins.data | 0 .../validation_damped_precession}/bench-spin-precession.in | 0 .../validation_damped_precession}/llg_precession.py | 0 .../validation_damped_precession}/plot_precession.py | 0 .../validation_damped_precession}/run-bench-prec.sh | 0 .../validation_langevin_precession}/bench-prec-spin.template | 0 .../validation_langevin_precession}/langevin.py | 0 .../validation_langevin_precession}/plot_precession.py | 0 .../validation_langevin_precession}/run-bench-prec.sh | 0 15 files changed, 1 insertion(+), 1 deletion(-) rename examples/SPIN/{benchmark => validation}/README (100%) rename examples/SPIN/{benchmark/benchmarck_damped_exchange => validation/validation_damped_exchange}/bench-spin-precession.in (100%) rename examples/SPIN/{benchmark/benchmarck_damped_exchange => validation/validation_damped_exchange}/llg_exchange.py (100%) rename examples/SPIN/{benchmark/benchmarck_damped_exchange => validation/validation_damped_exchange}/plot_precession.py (100%) rename examples/SPIN/{benchmark/benchmarck_damped_exchange => validation/validation_damped_exchange}/run-bench-exchange.sh (100%) rename examples/SPIN/{benchmark/benchmarck_damped_exchange => validation/validation_damped_exchange}/two_spins.data (100%) rename examples/SPIN/{benchmark/benchmarck_damped_precession => validation/validation_damped_precession}/bench-spin-precession.in (100%) rename examples/SPIN/{benchmark/benchmarck_damped_precession => validation/validation_damped_precession}/llg_precession.py (100%) rename examples/SPIN/{benchmark/benchmarck_damped_precession => validation/validation_damped_precession}/plot_precession.py (100%) rename examples/SPIN/{benchmark/benchmarck_damped_precession => validation/validation_damped_precession}/run-bench-prec.sh (100%) rename examples/SPIN/{benchmark/benchmarck_langevin_precession => validation/validation_langevin_precession}/bench-prec-spin.template (100%) rename examples/SPIN/{benchmark/benchmarck_langevin_precession => validation/validation_langevin_precession}/langevin.py (100%) rename examples/SPIN/{benchmark/benchmarck_langevin_precession => validation/validation_langevin_precession}/plot_precession.py (100%) rename examples/SPIN/{benchmark/benchmarck_langevin_precession => validation/validation_langevin_precession}/run-bench-prec.sh (100%) diff --git a/examples/SPIN/read_restart/in.spin.restart b/examples/SPIN/read_restart/in.spin.restart index ccce25b254..ad6f337890 100644 --- a/examples/SPIN/read_restart/in.spin.restart +++ b/examples/SPIN/read_restart/in.spin.restart @@ -44,6 +44,6 @@ thermo_style custom step time v_magnorm v_emag v_tmag temp etotal thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] run 100 diff --git a/examples/SPIN/benchmark/README b/examples/SPIN/validation/README similarity index 100% rename from examples/SPIN/benchmark/README rename to examples/SPIN/validation/README diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in b/examples/SPIN/validation/validation_damped_exchange/bench-spin-precession.in similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_exchange/bench-spin-precession.in rename to examples/SPIN/validation/validation_damped_exchange/bench-spin-precession.in diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py b/examples/SPIN/validation/validation_damped_exchange/llg_exchange.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_exchange/llg_exchange.py rename to examples/SPIN/validation/validation_damped_exchange/llg_exchange.py diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py b/examples/SPIN/validation/validation_damped_exchange/plot_precession.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_exchange/plot_precession.py rename to examples/SPIN/validation/validation_damped_exchange/plot_precession.py diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh b/examples/SPIN/validation/validation_damped_exchange/run-bench-exchange.sh similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_exchange/run-bench-exchange.sh rename to examples/SPIN/validation/validation_damped_exchange/run-bench-exchange.sh diff --git a/examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data b/examples/SPIN/validation/validation_damped_exchange/two_spins.data similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_exchange/two_spins.data rename to examples/SPIN/validation/validation_damped_exchange/two_spins.data diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in b/examples/SPIN/validation/validation_damped_precession/bench-spin-precession.in similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_precession/bench-spin-precession.in rename to examples/SPIN/validation/validation_damped_precession/bench-spin-precession.in diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py b/examples/SPIN/validation/validation_damped_precession/llg_precession.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_precession/llg_precession.py rename to examples/SPIN/validation/validation_damped_precession/llg_precession.py diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py b/examples/SPIN/validation/validation_damped_precession/plot_precession.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_precession/plot_precession.py rename to examples/SPIN/validation/validation_damped_precession/plot_precession.py diff --git a/examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh b/examples/SPIN/validation/validation_damped_precession/run-bench-prec.sh similarity index 100% rename from examples/SPIN/benchmark/benchmarck_damped_precession/run-bench-prec.sh rename to examples/SPIN/validation/validation_damped_precession/run-bench-prec.sh diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template b/examples/SPIN/validation/validation_langevin_precession/bench-prec-spin.template similarity index 100% rename from examples/SPIN/benchmark/benchmarck_langevin_precession/bench-prec-spin.template rename to examples/SPIN/validation/validation_langevin_precession/bench-prec-spin.template diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py b/examples/SPIN/validation/validation_langevin_precession/langevin.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_langevin_precession/langevin.py rename to examples/SPIN/validation/validation_langevin_precession/langevin.py diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py b/examples/SPIN/validation/validation_langevin_precession/plot_precession.py similarity index 100% rename from examples/SPIN/benchmark/benchmarck_langevin_precession/plot_precession.py rename to examples/SPIN/validation/validation_langevin_precession/plot_precession.py diff --git a/examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh b/examples/SPIN/validation/validation_langevin_precession/run-bench-prec.sh similarity index 100% rename from examples/SPIN/benchmark/benchmarck_langevin_precession/run-bench-prec.sh rename to examples/SPIN/validation/validation_langevin_precession/run-bench-prec.sh From a0c51b40b9da8746242b02dc92a94fa6caa48014 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 19 Nov 2019 12:54:30 -0700 Subject: [PATCH 486/557] Commit2 JT 111919 - renaming validation directory --- examples/SPIN/{validation => test_problems}/README | 0 .../validation_damped_exchange/bench-spin-precession.in | 0 .../validation_damped_exchange/llg_exchange.py | 0 .../validation_damped_exchange/plot_precession.py | 0 .../validation_damped_exchange/run-bench-exchange.sh | 0 .../validation_damped_exchange/two_spins.data | 0 .../validation_damped_precession/bench-spin-precession.in | 0 .../validation_damped_precession/llg_precession.py | 0 .../validation_damped_precession/plot_precession.py | 0 .../validation_damped_precession/run-bench-prec.sh | 0 .../validation_langevin_precession/bench-prec-spin.template | 0 .../validation_langevin_precession/langevin.py | 0 .../validation_langevin_precession/plot_precession.py | 0 .../validation_langevin_precession/run-bench-prec.sh | 0 14 files changed, 0 insertions(+), 0 deletions(-) rename examples/SPIN/{validation => test_problems}/README (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_exchange/bench-spin-precession.in (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_exchange/llg_exchange.py (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_exchange/plot_precession.py (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_exchange/run-bench-exchange.sh (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_exchange/two_spins.data (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_precession/bench-spin-precession.in (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_precession/llg_precession.py (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_precession/plot_precession.py (100%) rename examples/SPIN/{validation => test_problems}/validation_damped_precession/run-bench-prec.sh (100%) rename examples/SPIN/{validation => test_problems}/validation_langevin_precession/bench-prec-spin.template (100%) rename examples/SPIN/{validation => test_problems}/validation_langevin_precession/langevin.py (100%) rename examples/SPIN/{validation => test_problems}/validation_langevin_precession/plot_precession.py (100%) rename examples/SPIN/{validation => test_problems}/validation_langevin_precession/run-bench-prec.sh (100%) diff --git a/examples/SPIN/validation/README b/examples/SPIN/test_problems/README similarity index 100% rename from examples/SPIN/validation/README rename to examples/SPIN/test_problems/README diff --git a/examples/SPIN/validation/validation_damped_exchange/bench-spin-precession.in b/examples/SPIN/test_problems/validation_damped_exchange/bench-spin-precession.in similarity index 100% rename from examples/SPIN/validation/validation_damped_exchange/bench-spin-precession.in rename to examples/SPIN/test_problems/validation_damped_exchange/bench-spin-precession.in diff --git a/examples/SPIN/validation/validation_damped_exchange/llg_exchange.py b/examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py similarity index 100% rename from examples/SPIN/validation/validation_damped_exchange/llg_exchange.py rename to examples/SPIN/test_problems/validation_damped_exchange/llg_exchange.py diff --git a/examples/SPIN/validation/validation_damped_exchange/plot_precession.py b/examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py similarity index 100% rename from examples/SPIN/validation/validation_damped_exchange/plot_precession.py rename to examples/SPIN/test_problems/validation_damped_exchange/plot_precession.py diff --git a/examples/SPIN/validation/validation_damped_exchange/run-bench-exchange.sh b/examples/SPIN/test_problems/validation_damped_exchange/run-bench-exchange.sh similarity index 100% rename from examples/SPIN/validation/validation_damped_exchange/run-bench-exchange.sh rename to examples/SPIN/test_problems/validation_damped_exchange/run-bench-exchange.sh diff --git a/examples/SPIN/validation/validation_damped_exchange/two_spins.data b/examples/SPIN/test_problems/validation_damped_exchange/two_spins.data similarity index 100% rename from examples/SPIN/validation/validation_damped_exchange/two_spins.data rename to examples/SPIN/test_problems/validation_damped_exchange/two_spins.data diff --git a/examples/SPIN/validation/validation_damped_precession/bench-spin-precession.in b/examples/SPIN/test_problems/validation_damped_precession/bench-spin-precession.in similarity index 100% rename from examples/SPIN/validation/validation_damped_precession/bench-spin-precession.in rename to examples/SPIN/test_problems/validation_damped_precession/bench-spin-precession.in diff --git a/examples/SPIN/validation/validation_damped_precession/llg_precession.py b/examples/SPIN/test_problems/validation_damped_precession/llg_precession.py similarity index 100% rename from examples/SPIN/validation/validation_damped_precession/llg_precession.py rename to examples/SPIN/test_problems/validation_damped_precession/llg_precession.py diff --git a/examples/SPIN/validation/validation_damped_precession/plot_precession.py b/examples/SPIN/test_problems/validation_damped_precession/plot_precession.py similarity index 100% rename from examples/SPIN/validation/validation_damped_precession/plot_precession.py rename to examples/SPIN/test_problems/validation_damped_precession/plot_precession.py diff --git a/examples/SPIN/validation/validation_damped_precession/run-bench-prec.sh b/examples/SPIN/test_problems/validation_damped_precession/run-bench-prec.sh similarity index 100% rename from examples/SPIN/validation/validation_damped_precession/run-bench-prec.sh rename to examples/SPIN/test_problems/validation_damped_precession/run-bench-prec.sh diff --git a/examples/SPIN/validation/validation_langevin_precession/bench-prec-spin.template b/examples/SPIN/test_problems/validation_langevin_precession/bench-prec-spin.template similarity index 100% rename from examples/SPIN/validation/validation_langevin_precession/bench-prec-spin.template rename to examples/SPIN/test_problems/validation_langevin_precession/bench-prec-spin.template diff --git a/examples/SPIN/validation/validation_langevin_precession/langevin.py b/examples/SPIN/test_problems/validation_langevin_precession/langevin.py similarity index 100% rename from examples/SPIN/validation/validation_langevin_precession/langevin.py rename to examples/SPIN/test_problems/validation_langevin_precession/langevin.py diff --git a/examples/SPIN/validation/validation_langevin_precession/plot_precession.py b/examples/SPIN/test_problems/validation_langevin_precession/plot_precession.py similarity index 100% rename from examples/SPIN/validation/validation_langevin_precession/plot_precession.py rename to examples/SPIN/test_problems/validation_langevin_precession/plot_precession.py diff --git a/examples/SPIN/validation/validation_langevin_precession/run-bench-prec.sh b/examples/SPIN/test_problems/validation_langevin_precession/run-bench-prec.sh similarity index 100% rename from examples/SPIN/validation/validation_langevin_precession/run-bench-prec.sh rename to examples/SPIN/test_problems/validation_langevin_precession/run-bench-prec.sh From 3dc8b7b6e574dc424e8c750b3ca261f79e22c9b3 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 15:30:30 -0500 Subject: [PATCH 487/557] update rst files with changes to .txt versions --- doc/src/compute_spin.rst | 16 +++++++--------- doc/src/fix_precession_spin.rst | 34 ++++++++++++++++++++++++++++++--- doc/src/pair_spin_exchange.rst | 5 +++-- 3 files changed, 41 insertions(+), 14 deletions(-) diff --git a/doc/src/compute_spin.rst b/doc/src/compute_spin.rst index 4dd3103d78..7538746911 100644 --- a/doc/src/compute_spin.rst +++ b/doc/src/compute_spin.rst @@ -28,17 +28,15 @@ Description Define a computation that calculates magnetic quantities for a system of atoms having spins. -This compute calculates 6 magnetic quantities. +This compute calculates the following 6 magnetic quantities: -The three first quantities are the x,y and z coordinates of the total -magnetization. +* the three first quantities are the x,y and z coordinates of the total + magnetization, +* the fourth quantity is the norm of the total magnetization, +* The fifth quantity is the magnetic energy (in eV), +* The sixth one is referred to as the spin temperature, according + to the work of :ref:`(Nurdin) `. -The fourth quantity is the norm of the total magnetization. - -The fifth quantity is the magnetic energy. - -The sixth one is referred to as the spin temperature, according -to the work of :ref:`(Nurdin) `. The simplest way to output the results of the compute spin calculation is to define some of the quantities as variables, and to use the thermo and diff --git a/doc/src/fix_precession_spin.rst b/doc/src/fix_precession_spin.rst index f2b99fa4a2..e47b9bd855 100644 --- a/doc/src/fix_precession_spin.rst +++ b/doc/src/fix_precession_spin.rst @@ -53,11 +53,39 @@ Style *zeeman* is used for the simulation of the interaction between the magnetic spins in the defined group and an external magnetic field: -.. image:: Eqs/force_spin_zeeman.jpg +.. image:: Eqs/fix_spin_zeeman.jpg :align: center -with mu0 the vacuum permeability, muB the Bohr magneton (muB = 5.788 eV/T -in metal units). +with: + +* Bext the external magnetic field (in T) +* g the Lande factor (hard-coded as g=2.0) +* si the unitary vector describing the orientation of spin i +* mui the atomic moment of spin i given as a multiple of the + Bohr magneton muB (for example, mui ~ 2.2 in bulk iron). + + +The field value in Tesla is multiplied by the gyromagnetic +ratio, g\*muB/hbar, converting it into a precession frequency in +rad.THz (in metal units and with muB = 5.788 eV/T). + +As a comparison, the figure below displays the simulation of a +single spin (of norm mui = 1.0) submitted to an external +magnetic field of \|Bext\| = 10.0 Tesla (and oriented along the z +axis). +The upper plot shows the average magnetization along the +external magnetic field axis and the lower plot the Zeeman +energy, both as a function of temperature. +The reference result is provided by the plot of the Langevin +function for the same parameters. + +.. image:: JPG/zeeman_langevin.jpg + :align: center + +The temperature effects are accounted for by connecting the spin +i to a thermal bath using a Langevin thermostat (see +:doc:`fix\_langevin\_spin ` for the definition of +this thermostat). Style *anisotropy* is used to simulate an easy axis or an easy plane for the magnetic spins in the defined group: diff --git a/doc/src/pair_spin_exchange.rst b/doc/src/pair_spin_exchange.rst index 44533b69a0..5f7a630c60 100644 --- a/doc/src/pair_spin_exchange.rst +++ b/doc/src/pair_spin_exchange.rst @@ -34,7 +34,7 @@ pairs of magnetic spins: :align: center where si and sj are two neighboring magnetic spins of two particles, -rij = ri - rj is the inter-atomic distance between the two particles, +rij = \|ri - rj\| is the inter-atomic distance between the two particles, and J(rij) is a function defining the intensity and the sign of the exchange interaction for different neighboring shells. This function is defined as: @@ -42,7 +42,8 @@ interaction for different neighboring shells. This function is defined as: :align: center where a, b and d are the three constant coefficients defined in the associated -"pair\_coeff" command (see below for more explanations). +"pair\_coeff" command, and Rc is the radius cutoff associated to +the pair interaction (see below for more explanations). The coefficients a, b, and d need to be fitted so that the function above matches with the value of the exchange interaction for the N neighbor shells taken into account. From 2a943241ae39ffa4504c26faedec3ff594c93852 Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 15:33:44 -0500 Subject: [PATCH 488/557] update doc/src/.gitignore --- doc/src/.gitignore | 5 +++-- 1 file changed, 3 insertions(+), 2 deletions(-) diff --git a/doc/src/.gitignore b/doc/src/.gitignore index be126ab4aa..e0b9693457 100644 --- a/doc/src/.gitignore +++ b/doc/src/.gitignore @@ -1,2 +1,3 @@ -Eqs -JPG +/Eqs +/JPG +/false_positives.txt From 280d0defec658c06530a6d64bab730ad129ab1fc Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 15:35:31 -0500 Subject: [PATCH 489/557] whitespace cleanup --- src/SPIN/fix_precession_spin.cpp | 2 +- src/SPIN/pair_spin_dipole_long.h | 4 ++-- 2 files changed, 3 insertions(+), 3 deletions(-) diff --git a/src/SPIN/fix_precession_spin.cpp b/src/SPIN/fix_precession_spin.cpp index d06d70bc8c..2d55de33ea 100644 --- a/src/SPIN/fix_precession_spin.cpp +++ b/src/SPIN/fix_precession_spin.cpp @@ -353,7 +353,7 @@ void FixPrecessionSpin::compute_cubic(double spi[3], double fmi[3]) sixx = k2ch*(nc1x*six1 + nc2x*six2 + nc3x*six3); sixy = k2ch*(nc1y*six1 + nc2y*six2 + nc3y*six3); sixz = k2ch*(nc1z*six1 + nc2z*six2 + nc3z*six3); - + fmi[0] += (fourx + sixx); fmi[1] += (foury + sixy); fmi[2] += (fourz + sixz); diff --git a/src/SPIN/pair_spin_dipole_long.h b/src/SPIN/pair_spin_dipole_long.h index 61ae427e26..1ec30cdb93 100644 --- a/src/SPIN/pair_spin_dipole_long.h +++ b/src/SPIN/pair_spin_dipole_long.h @@ -49,8 +49,8 @@ class PairSpinDipoleLong : public PairSpin { void read_restart(FILE *); void write_restart_settings(FILE *); void read_restart_settings(FILE *); - - double cut_spin_long_global; // global long cutoff distance + + double cut_spin_long_global; // global long cutoff distance protected: double hbar; // reduced Planck's constant From 3525c13653fd8711edd9c9c2bdfa1fd917dda76a Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 16:36:09 -0500 Subject: [PATCH 490/557] need to make certain, that cvflag_atom is always initialized --- src/pair.cpp | 1 + 1 file changed, 1 insertion(+) diff --git a/src/pair.cpp b/src/pair.cpp index d27991678c..0cedc18620 100644 --- a/src/pair.cpp +++ b/src/pair.cpp @@ -784,6 +784,7 @@ void Pair::ev_setup(int eflag, int vflag, int alloc) vflag_global = vflag % 4; vflag_atom = vflag & 4; + cvflag_atom = 0; if (vflag & 8) { if (centroidstressflag & 2) { From 6b3421c966dbfa03e740ed836de51adcb030372e Mon Sep 17 00:00:00 2001 From: Axel Kohlmeyer Date: Tue, 19 Nov 2019 17:23:03 -0500 Subject: [PATCH 491/557] silence compiler warning --- src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) 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 f365f91f43..d51382c0f1 100644 --- a/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp +++ b/src/USER-OMP/pair_lj_cut_tip4p_long_omp.cpp @@ -145,7 +145,7 @@ void PairLJCutTIP4PLongOMP::eval(int iifrom, int iito, ThrData * const thr) dbl3_t x1,x2,xH1,xH2; int *ilist,*jlist,*numneigh,**firstneigh; - int i,j,ii,jj,jnum,itype,jtype,itable, key; + int i,j,ii,jj,jnum,itype,jtype,itable, key=0; int n,vlist[6]; int iH1,iH2,jH1,jH2; From b4ba356f7b7a4c83d813b95c9e4ce4aa521665a5 Mon Sep 17 00:00:00 2001 From: julient31 Date: Tue, 19 Nov 2019 15:50:56 -0700 Subject: [PATCH 492/557] Commit JT 111919 - generated fresh log. files in examples - corrected some of the examples --- examples/SPIN/bfo/in.spin.bfo | 5 +- examples/SPIN/bfo/log.11May18.spin.bfo.g++.1 | 212 - examples/SPIN/bfo/log.11May18.spin.bfo.g++.4 | 212 - examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 | 167 + examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 | 167 + .../log.11May18.spin.cobalt_fcc.g++.1 | 142 - .../log.11May18.spin.cobalt_fcc.g++.4 | 142 - .../log.19Nov19.spin.cobalt_fcc.g++.1 | 142 + .../log.19Nov19.spin.cobalt_fcc.g++.4 | 142 + examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp | 2 +- .../log.11May18.spin.cobalt_hcp.g++.1 | 318 - .../log.11May18.spin.cobalt_hcp.g++.4 | 318 - .../log.19Nov19.spin.cobalt_hcp.g++.1 | 219 + .../log.19Nov19.spin.cobalt_hcp.g++.4 | 219 + .../SPIN/dipole_spin/in.spin.iron_dipole_cut | 4 +- .../dipole_spin/in.spin.iron_dipole_ewald | 4 +- .../SPIN/dipole_spin/in.spin.iron_dipole_pppm | 4 +- .../log.19Nov19.spin.iron_dipole_cut.g++.1 | 125 + .../log.19Nov19.spin.iron_dipole_cut.g++.4 | 125 + .../log.19Nov19.spin.iron_dipole_ewald.g++.1 | 135 + .../log.19Nov19.spin.iron_dipole_ewald.g++.4 | 135 + .../log.19Nov19.spin.iron_dipole_pppm.g++.1 | 137 + .../log.19Nov19.spin.iron_dipole_pppm.g++.4 | 137 + examples/SPIN/iron/in.spin.iron | 6 +- examples/SPIN/iron/in.spin.iron_cubic | 2 +- .../SPIN/iron/log.19Nov19.spin.iron.g++.1 | 136 + .../SPIN/iron/log.19Nov19.spin.iron.g++.4 | 136 + ...++.1 => log.19Nov19.spin.iron_cubic.g++.1} | 66 +- ...++.4 => log.19Nov19.spin.iron_cubic.g++.4} | 76 +- .../SPIN/iron/log.30Apr19.spin.iron.g++.1 | 1117 --- .../SPIN/iron/log.30Apr19.spin.iron.g++.4 | 1117 --- examples/SPIN/nickel/in.spin.nickel | 67 +- examples/SPIN/nickel/in.spin.nickel_cubic | 4 +- .../SPIN/nickel/log.19Nov19.spin.nickel.g++.1 | 136 + .../SPIN/nickel/log.19Nov19.spin.nickel.g++.4 | 136 + ....1 => log.19Nov19.spin.nickel_cubic.g++.1} | 106 +- ....4 => log.19Nov19.spin.nickel_cubic.g++.4} | 118 +- .../SPIN/nickel/log.30Apr19.spin.nickel.g++.1 | 159 - .../SPIN/nickel/log.30Apr19.spin.nickel.g++.4 | 159 - .../read_restart/Co_PurjaPun_2012.eam.alloy | 6007 ++++++++++++++++- examples/SPIN/read_restart/in.spin.restart | 2 +- .../log.11May18.spin.read_data.g++.4 | 112 - .../log.11May18.spin.restart.g++.4 | 118 - ...g++.1 => log.19Nov19.spin.read_data.g++.1} | 53 +- .../log.19Nov19.spin.read_data.g++.4 | 113 + ...t.g++.1 => log.19Nov19.spin.restart.g++.1} | 50 +- .../log.19Nov19.spin.restart.g++.4 | 118 + ...1 => log.19Nov19.spin.write_restart.g++.1} | 48 +- ...4 => log.19Nov19.spin.write_restart.g++.4} | 48 +- examples/SPIN/run_spin_examples.sh | 120 + .../{in.spinmin.setforce => in.spin.setforce} | 8 +- .../log.19Nov19.spin.setforce.g++.1 | 141 + .../log.19Nov19.spin.setforce.g++.4 | 141 + .../{in.spinmin.bfo => in.spin.bfo_min} | 2 +- .../{in.spinmin_cg.bfo => in.spin.bfo_min_cg} | 4 +- ...pinmin_lbfgs.bfo => in.spin.bfo_min_lbfgs} | 2 +- .../{in.spinmin.iron => in.spin.iron_min} | 4 +- .../spinmin/log.19Nov19.spin.bfo_min.g++.1 | 148 + .../spinmin/log.19Nov19.spin.bfo_min.g++.4 | 148 + .../spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 | 141 + .../spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 | 141 + .../log.19Nov19.spin.bfo_min_lbfgs.g++.1 | 139 + .../log.19Nov19.spin.bfo_min_lbfgs.g++.4 | 139 + .../spinmin/log.19Nov19.spin.iron_min.g++.1 | 126 + .../spinmin/log.19Nov19.spin.iron_min.g++.4 | 126 + 65 files changed, 10439 insertions(+), 4514 deletions(-) delete mode 100644 examples/SPIN/bfo/log.11May18.spin.bfo.g++.1 delete mode 100644 examples/SPIN/bfo/log.11May18.spin.bfo.g++.4 create mode 100644 examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 create mode 100644 examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 delete mode 100644 examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.1 delete mode 100644 examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.4 create mode 100644 examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 create mode 100644 examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 delete mode 100644 examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.1 delete mode 100644 examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.4 create mode 100644 examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 create mode 100644 examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 create mode 100644 examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 create mode 100644 examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 create mode 100644 examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 rename examples/SPIN/iron/{log.30Apr19.spin.iron_cubic.g++.1 => log.19Nov19.spin.iron_cubic.g++.1} (59%) rename examples/SPIN/iron/{log.30Apr19.spin.iron_cubic.g++.4 => log.19Nov19.spin.iron_cubic.g++.4} (58%) delete mode 100644 examples/SPIN/iron/log.30Apr19.spin.iron.g++.1 delete mode 100644 examples/SPIN/iron/log.30Apr19.spin.iron.g++.4 create mode 100644 examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 create mode 100644 examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 rename examples/SPIN/nickel/{log.30Apr19.spin.nickel_cubic.g++.1 => log.19Nov19.spin.nickel_cubic.g++.1} (54%) rename examples/SPIN/nickel/{log.30Apr19.spin.nickel_cubic.g++.4 => log.19Nov19.spin.nickel_cubic.g++.4} (52%) delete mode 100644 examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.1 delete mode 100644 examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.4 mode change 120000 => 100644 examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy delete mode 100644 examples/SPIN/read_restart/log.11May18.spin.read_data.g++.4 delete mode 100644 examples/SPIN/read_restart/log.11May18.spin.restart.g++.4 rename examples/SPIN/read_restart/{log.11May18.spin.read_data.g++.1 => log.19Nov19.spin.read_data.g++.1} (50%) create mode 100644 examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 rename examples/SPIN/read_restart/{log.11May18.spin.restart.g++.1 => log.19Nov19.spin.restart.g++.1} (54%) create mode 100644 examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 rename examples/SPIN/read_restart/{log.11May18.spin.write_restart.g++.1 => log.19Nov19.spin.write_restart.g++.1} (64%) rename examples/SPIN/read_restart/{log.11May18.spin.write_restart.g++.4 => log.19Nov19.spin.write_restart.g++.4} (64%) create mode 100755 examples/SPIN/run_spin_examples.sh rename examples/SPIN/setforce_spin/{in.spinmin.setforce => in.spin.setforce} (86%) create mode 100644 examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 create mode 100644 examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 rename examples/SPIN/spinmin/{in.spinmin.bfo => in.spin.bfo_min} (97%) rename examples/SPIN/spinmin/{in.spinmin_cg.bfo => in.spin.bfo_min_cg} (94%) rename examples/SPIN/spinmin/{in.spinmin_lbfgs.bfo => in.spin.bfo_min_lbfgs} (97%) rename examples/SPIN/spinmin/{in.spinmin.iron => in.spin.iron_min} (94%) create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 create mode 100644 examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 diff --git a/examples/SPIN/bfo/in.spin.bfo b/examples/SPIN/bfo/in.spin.bfo index a32dde9dd7..b97f7e2d61 100644 --- a/examples/SPIN/bfo/in.spin.bfo +++ b/examples/SPIN/bfo/in.spin.bfo @@ -1,9 +1,7 @@ # layer sc iron atoms (in the [001] plane) in bismuth oxide -clear units metal atom_style spin - dimension 3 boundary p p f @@ -18,7 +16,6 @@ create_atoms 1 box # setting mass, mag. moments, and interactions for bfo mass 1 1.0 - set group all spin/random 11 2.50 #pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 @@ -53,4 +50,4 @@ thermo 10 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 500 diff --git a/examples/SPIN/bfo/log.11May18.spin.bfo.g++.1 b/examples/SPIN/bfo/log.11May18.spin.bfo.g++.1 deleted file mode 100644 index 8e9eb82d1f..0000000000 --- a/examples/SPIN/bfo/log.11May18.spin.bfo.g++.1 +++ /dev/null @@ -1,212 +0,0 @@ -LAMMPS (11 May 2018) -# layer sc iron atoms (in the [001] plane) in bismuth oxide - -clear -units metal -atom_style spin - -dimension 3 -boundary p p f - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice sc 3.96 -Lattice spacing in x,y,z = 3.96 3.96 3.96 -region box block 0.0 34.0 0.0 34.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 5780 atoms - Time spent = 0.0013566 secs - -# setting mass, mag. moments, and interactions for bfo - -mass 1 1.0 - -set group all spin/random 11 2.50 - 5780 settings made for spin/random - -pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 -pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 -pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.1 21 -fix 3 all nve/spin lattice no - -timestep 0.0002 - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 5000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.1 - ghost atom cutoff = 6.1 - binsize = 3.05, bins = 45 45 7 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (2) pair spin/magelec, perpetual, copy from (1) - attributes: full, newton on - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 7.272 | 7.272 | 7.272 Mbytes -Step Time v_magnorm v_emag Temp TotEng - 0 0 0.010071723 -0.13298298 0 -0.12034311 - 50 0.01 0.0098643821 -1.3898985 0 -1.3772103 - 100 0.02 0.0096526211 -2.6381677 0 -2.6254222 - 150 0.03 0.0094342235 -3.8784006 0 -3.8656019 - 200 0.04 0.0092074832 -5.111441 0 -5.0986001 - 250 0.05 0.0089713115 -6.3380611 0 -6.3251904 - 300 0.06 0.0087256081 -7.5587787 0 -7.5458894 - 350 0.07 0.0084715548 -8.7738491 0 -8.7609521 - 400 0.08 0.008211486 -9.9833855 0 -9.9704932 - 450 0.09 0.0079483243 -11.18751 0 -11.174637 - 500 0.1 0.0076849713 -12.386462 0 -12.37362 - 550 0.11 0.007424064 -13.580633 0 -13.567832 - 600 0.12 0.0071680699 -14.770519 0 -14.757759 - 650 0.13 0.0069192726 -15.956579 0 -15.943853 - 700 0.14 0.0066793495 -17.139049 0 -17.126343 - 750 0.15 0.0064488038 -18.317803 0 -18.305099 - 800 0.16 0.0062267571 -19.492336 0 -19.479616 - 850 0.17 0.0060112235 -20.661925 0 -20.649176 - 900 0.18 0.0057995251 -21.825931 0 -21.813141 - 950 0.19 0.0055886511 -22.98413 0 -22.971297 - 1000 0.2 0.0053757923 -24.136967 0 -24.124095 - 1050 0.21 0.0051592263 -25.285621 0 -25.272717 - 1100 0.22 0.0049391661 -26.431928 0 -26.419004 - 1150 0.23 0.0047179149 -27.578212 0 -27.565281 - 1200 0.24 0.0044991004 -28.727051 0 -28.714128 - 1250 0.25 0.0042864034 -29.880967 0 -29.868062 - 1300 0.26 0.0040824475 -31.042054 0 -31.029173 - 1350 0.27 0.0038883007 -32.21165 0 -32.198795 - 1400 0.28 0.0037036595 -33.390159 0 -33.377326 - 1450 0.29 0.0035274815 -34.577121 0 -34.564302 - 1500 0.3 0.0033587207 -35.771483 0 -35.758672 - 1550 0.31 0.0031969501 -36.971996 0 -36.95919 - 1600 0.32 0.0030429081 -38.177601 0 -38.164801 - 1650 0.33 0.0028989804 -39.387757 0 -39.374962 - 1700 0.34 0.0027692024 -40.602665 0 -40.589873 - 1750 0.35 0.0026581403 -41.823341 0 -41.81054 - 1800 0.36 0.0025686991 -43.05145 0 -43.038628 - 1850 0.37 0.002500124 -44.288966 0 -44.276111 - 1900 0.38 0.0024477804 -45.537752 0 -45.52486 - 1950 0.39 0.0024050049 -46.799255 0 -46.786336 - 2000 0.4 0.0023657031 -48.074388 0 -48.061466 - 2050 0.41 0.0023260844 -49.363587 0 -49.350695 - 2100 0.42 0.0022848329 -50.666866 0 -50.654039 - 2150 0.43 0.0022419759 -51.983781 0 -51.971055 - 2200 0.44 0.0021972506 -53.31336 0 -53.300764 - 2250 0.45 0.0021488322 -54.654121 0 -54.641676 - 2300 0.46 0.0020929483 -56.004207 0 -55.991918 - 2350 0.47 0.0020244601 -57.361586 0 -57.349442 - 2400 0.48 0.001938225 -58.72428 0 -58.712247 - 2450 0.49 0.0018309419 -60.09064 0 -60.078671 - 2500 0.5 0.0017030436 -61.459658 0 -61.447705 - 2550 0.51 0.0015599449 -62.831213 0 -62.819237 - 2600 0.52 0.0014117554 -64.206088 0 -64.194074 - 2650 0.53 0.0012709942 -65.585701 0 -65.573657 - 2700 0.54 0.0011490452 -66.971565 0 -66.959515 - 2750 0.55 0.001053009 -68.364663 0 -68.352635 - 2800 0.56 0.00098415327 -69.765002 0 -69.753017 - 2850 0.57 0.00093809306 -71.171532 0 -71.159598 - 2900 0.58 0.00090656933 -72.58234 0 -72.570459 - 2950 0.59 0.00088069677 -73.994931 0 -73.983099 - 3000 0.6 0.00085472643 -75.406507 0 -75.39472 - 3050 0.61 0.00082842902 -76.814319 0 -76.802575 - 3100 0.62 0.00080642618 -78.216074 0 -78.204373 - 3150 0.63 0.00079463972 -79.610246 0 -79.598589 - 3200 0.64 0.0007962304 -80.996103 0 -80.984494 - 3250 0.65 0.00080980411 -82.37346 0 -82.361903 - 3300 0.66 0.00083070982 -83.742356 0 -83.730855 - 3350 0.67 0.00085389185 -85.102808 0 -85.091374 - 3400 0.68 0.00087624091 -86.454619 0 -86.443259 - 3450 0.69 0.00089741986 -87.797089 0 -87.785814 - 3500 0.7 0.00091910796 -89.12875 0 -89.117567 - 3550 0.71 0.00094318459 -90.447312 0 -90.436232 - 3600 0.72 0.00096989367 -91.750008 0 -91.739046 - 3650 0.73 0.00099713096 -93.034224 0 -93.023402 - 3700 0.74 0.0010212995 -94.298186 0 -94.287529 - 3750 0.75 0.0010391164 -95.5414 0 -95.530926 - 3800 0.76 0.0010491462 -96.764626 0 -96.754338 - 3850 0.77 0.0010521238 -97.969346 0 -97.95923 - 3900 0.78 0.0010500324 -99.156875 0 -99.146899 - 3950 0.79 0.0010447043 -100.32743 0 -100.31756 - 4000 0.8 0.0010368986 -101.4796 0 -101.46978 - 4050 0.81 0.0010263632 -102.61044 0 -102.60064 - 4100 0.82 0.0010126933 -103.71619 0 -103.70639 - 4150 0.83 0.00099631895 -104.79338 0 -104.78358 - 4200 0.84 0.0009789075 -105.8398 0 -105.82998 - 4250 0.85 0.00096287608 -106.85496 0 -106.84515 - 4300 0.86 0.00095034023 -107.84011 0 -107.83029 - 4350 0.87 0.00094219078 -108.7976 0 -108.78778 - 4400 0.88 0.00093779428 -109.73016 0 -109.72031 - 4450 0.89 0.0009354459 -110.63996 0 -110.63008 - 4500 0.9 0.00093342614 -111.52805 0 -111.51812 - 4550 0.91 0.0009311077 -112.39417 0 -112.38416 - 4600 0.92 0.00092926689 -113.23706 0 -113.22697 - 4650 0.93 0.00092921566 -114.05512 0 -114.04495 - 4700 0.94 0.00093142598 -114.84701 0 -114.83675 - 4750 0.95 0.00093479851 -115.61197 0 -115.60164 - 4800 0.96 0.0009369799 -116.3499 0 -116.33951 - 4850 0.97 0.00093516768 -117.06128 0 -117.05084 - 4900 0.98 0.00092684411 -117.74695 0 -117.73645 - 4950 0.99 0.00091046222 -118.40798 0 -118.39742 - 5000 1 0.00088619957 -119.04554 0 -119.03492 -Loop time of 128.304 on 1 procs for 5000 steps with 5780 atoms - -Performance: 0.673 ns/day, 35.640 hours/ns, 38.970 timesteps/s -99.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 | 24.227 | 24.227 | 24.227 | 0.0 | 18.88 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.081048 | 0.081048 | 0.081048 | 0.0 | 0.06 -Output | 39.796 | 39.796 | 39.796 | 0.0 | 31.02 -Modify | 64.112 | 64.112 | 64.112 | 0.0 | 49.97 -Other | | 0.08788 | | | 0.07 - -Nlocal: 5780 ave 5780 max 5780 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1065 ave 1065 max 1065 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: 92480 ave 92480 max 92480 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 92480 -Ave neighs/atom = 16 -Neighbor list builds = 0 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:02:08 diff --git a/examples/SPIN/bfo/log.11May18.spin.bfo.g++.4 b/examples/SPIN/bfo/log.11May18.spin.bfo.g++.4 deleted file mode 100644 index c0f96b8195..0000000000 --- a/examples/SPIN/bfo/log.11May18.spin.bfo.g++.4 +++ /dev/null @@ -1,212 +0,0 @@ -LAMMPS (11 May 2018) -# layer sc iron atoms (in the [001] plane) in bismuth oxide - -clear -units metal -atom_style spin - -dimension 3 -boundary p p f - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice sc 3.96 -Lattice spacing in x,y,z = 3.96 3.96 3.96 -region box block 0.0 34.0 0.0 34.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) - 2 by 2 by 1 MPI processor grid -create_atoms 1 box -Created 5780 atoms - Time spent = 0.000355959 secs - -# setting mass, mag. moments, and interactions for bfo - -mass 1 1.0 - -set group all spin/random 11 2.50 - 5780 settings made for spin/random - -pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 -pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 -pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.1 21 -fix 3 all nve/spin lattice no - -timestep 0.0002 - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 5000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.1 - ghost atom cutoff = 6.1 - binsize = 3.05, bins = 45 45 7 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard - (2) pair spin/magelec, perpetual, copy from (1) - attributes: full, newton on - pair build: copy - stencil: none - bin: none -Per MPI rank memory allocation (min/avg/max) = 6.862 | 6.862 | 6.862 Mbytes -Step Time v_magnorm v_emag Temp TotEng - 0 0 0.010071723 -0.13298298 0 -0.12034311 - 50 0.01 0.0098643821 -1.3898985 0 -1.3772103 - 100 0.02 0.009652621 -2.6381677 0 -2.6254222 - 150 0.03 0.0094342234 -3.8784007 0 -3.8656019 - 200 0.04 0.009207483 -5.1114411 0 -5.0986001 - 250 0.05 0.0089713114 -6.3380611 0 -6.3251904 - 300 0.06 0.0087256079 -7.5587787 0 -7.5458894 - 350 0.07 0.0084715546 -8.7738491 0 -8.7609521 - 400 0.08 0.0082114858 -9.9833855 0 -9.9704932 - 450 0.09 0.0079483242 -11.18751 0 -11.174637 - 500 0.1 0.0076849711 -12.386462 0 -12.37362 - 550 0.11 0.0074240638 -13.580633 0 -13.567832 - 600 0.12 0.0071680697 -14.770519 0 -14.757759 - 650 0.13 0.0069192724 -15.956579 0 -15.943853 - 700 0.14 0.0066793493 -17.139049 0 -17.126343 - 750 0.15 0.0064488035 -18.317803 0 -18.305099 - 800 0.16 0.0062267569 -19.492336 0 -19.479616 - 850 0.17 0.0060112233 -20.661925 0 -20.649176 - 900 0.18 0.005799525 -21.825931 0 -21.813141 - 950 0.19 0.0055886511 -22.98413 0 -22.971297 - 1000 0.2 0.0053757923 -24.136967 0 -24.124095 - 1050 0.21 0.0051592265 -25.285621 0 -25.272717 - 1100 0.22 0.0049391664 -26.431928 0 -26.419004 - 1150 0.23 0.0047179153 -27.578212 0 -27.565281 - 1200 0.24 0.0044991009 -28.727051 0 -28.714128 - 1250 0.25 0.0042864039 -29.880967 0 -29.868062 - 1300 0.26 0.004082448 -31.042054 0 -31.029174 - 1350 0.27 0.0038883012 -32.21165 0 -32.198795 - 1400 0.28 0.0037036599 -33.390159 0 -33.377326 - 1450 0.29 0.0035274817 -34.577121 0 -34.564302 - 1500 0.3 0.0033587208 -35.771483 0 -35.758672 - 1550 0.31 0.0031969501 -36.971996 0 -36.95919 - 1600 0.32 0.0030429079 -38.177601 0 -38.164801 - 1650 0.33 0.0028989801 -39.387757 0 -39.374962 - 1700 0.34 0.0027692022 -40.602666 0 -40.589873 - 1750 0.35 0.0026581401 -41.823341 0 -41.81054 - 1800 0.36 0.002568699 -43.05145 0 -43.038628 - 1850 0.37 0.0025001242 -44.288966 0 -44.276111 - 1900 0.38 0.0024477808 -45.537752 0 -45.52486 - 1950 0.39 0.0024050056 -46.799255 0 -46.786336 - 2000 0.4 0.002365704 -48.074388 0 -48.061466 - 2050 0.41 0.0023260854 -49.363587 0 -49.350695 - 2100 0.42 0.002284834 -50.666866 0 -50.654039 - 2150 0.43 0.0022419771 -51.983781 0 -51.971055 - 2200 0.44 0.0021972518 -53.31336 0 -53.300764 - 2250 0.45 0.0021488333 -54.654121 0 -54.641676 - 2300 0.46 0.0020929494 -56.004207 0 -55.991918 - 2350 0.47 0.0020244612 -57.361586 0 -57.349441 - 2400 0.48 0.0019382262 -58.72428 0 -58.712247 - 2450 0.49 0.001830943 -60.090639 0 -60.078671 - 2500 0.5 0.0017030446 -61.459658 0 -61.447704 - 2550 0.51 0.0015599459 -62.831213 0 -62.819237 - 2600 0.52 0.0014117562 -64.206088 0 -64.194074 - 2650 0.53 0.001270995 -65.5857 0 -65.573657 - 2700 0.54 0.001149046 -66.971565 0 -66.959515 - 2750 0.55 0.0010530098 -68.364663 0 -68.352635 - 2800 0.56 0.00098415418 -69.765002 0 -69.753017 - 2850 0.57 0.00093809402 -71.171532 0 -71.159598 - 2900 0.58 0.00090657031 -72.58234 0 -72.570459 - 2950 0.59 0.00088069773 -73.994931 0 -73.983099 - 3000 0.6 0.00085472731 -75.406507 0 -75.39472 - 3050 0.61 0.00082842975 -76.814319 0 -76.802575 - 3100 0.62 0.00080642669 -78.216074 0 -78.204373 - 3150 0.63 0.00079464 -79.610246 0 -79.59859 - 3200 0.64 0.00079623049 -80.996103 0 -80.984494 - 3250 0.65 0.00080980416 -82.373461 0 -82.361903 - 3300 0.66 0.00083070997 -83.742356 0 -83.730856 - 3350 0.67 0.00085389223 -85.102809 0 -85.091374 - 3400 0.68 0.00087624159 -86.454619 0 -86.44326 - 3450 0.69 0.00089742086 -87.79709 0 -87.785815 - 3500 0.7 0.00091910931 -89.12875 0 -89.117568 - 3550 0.71 0.00094318635 -90.447312 0 -90.436233 - 3600 0.72 0.00096989594 -91.750008 0 -91.739047 - 3650 0.73 0.00099713386 -93.034224 0 -93.023403 - 3700 0.74 0.0010213031 -94.298186 0 -94.287529 - 3750 0.75 0.0010391209 -95.541401 0 -95.530926 - 3800 0.76 0.0010491514 -96.764626 0 -96.754339 - 3850 0.77 0.0010521296 -97.969347 0 -97.959231 - 3900 0.78 0.0010500386 -99.156876 0 -99.146899 - 3950 0.79 0.0010447106 -100.32743 0 -100.31756 - 4000 0.8 0.0010369046 -101.4796 0 -101.46978 - 4050 0.81 0.0010263688 -102.61044 0 -102.60064 - 4100 0.82 0.0010126985 -103.71619 0 -103.70639 - 4150 0.83 0.00099632366 -104.79338 0 -104.78358 - 4200 0.84 0.00097891183 -105.8398 0 -105.82998 - 4250 0.85 0.00096288003 -106.85496 0 -106.84515 - 4300 0.86 0.00095034371 -107.84011 0 -107.83029 - 4350 0.87 0.00094219371 -108.7976 0 -108.78778 - 4400 0.88 0.00093779663 -109.73016 0 -109.72031 - 4450 0.89 0.00093544766 -110.63996 0 -110.63008 - 4500 0.9 0.00093342739 -111.52805 0 -111.51812 - 4550 0.91 0.00093110855 -112.39417 0 -112.38416 - 4600 0.92 0.00092926746 -113.23706 0 -113.22697 - 4650 0.93 0.00092921608 -114.05512 0 -114.04495 - 4700 0.94 0.0009314263 -114.84701 0 -114.83675 - 4750 0.95 0.0009347987 -115.61197 0 -115.60164 - 4800 0.96 0.00093697985 -116.3499 0 -116.33951 - 4850 0.97 0.00093516726 -117.06128 0 -117.05084 - 4900 0.98 0.00092684316 -117.74695 0 -117.73645 - 4950 0.99 0.00091046061 -118.40798 0 -118.39742 - 5000 1 0.00088619727 -119.04554 0 -119.03492 -Loop time of 37.142 on 4 procs for 5000 steps with 5780 atoms - -Performance: 2.326 ns/day, 10.317 hours/ns, 134.619 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 | 6.2804 | 6.3487 | 6.4569 | 2.7 | 17.09 -Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.15385 | 0.27957 | 0.36215 | 14.6 | 0.75 -Output | 10.573 | 10.784 | 10.994 | 4.8 | 29.03 -Modify | 19.48 | 19.707 | 19.925 | 3.7 | 53.06 -Other | | 0.02255 | | | 0.06 - -Nlocal: 1445 ave 1445 max 1445 min -Histogram: 4 0 0 0 0 0 0 0 0 0 -Nghost: 555 ave 555 max 555 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: 23120 ave 23120 max 23120 min -Histogram: 4 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 92480 -Ave neighs/atom = 16 -Neighbor list builds = 0 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:37 diff --git a/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 new file mode 100644 index 0000000000..e7eb5cea59 --- /dev/null +++ b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.1 @@ -0,0 +1,167 @@ +LAMMPS (30 Oct 2019) +# layer sc iron atoms (in the [001] plane) in bismuth oxide + +units metal +atom_style spin +dimension 3 +boundary p p f + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.00234604 secs + +# setting mass, mag. moments, and interactions for bfo + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +#pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.1 21 +fix 3 all nve/spin lattice frozen + +timestep 0.0002 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +#thermo_style custom step time v_magnorm v_emag temp etotal +thermo_style custom step time v_magnorm pe ke v_emag temp etotal +thermo 10 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 500 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 8.154 | 8.154 | 8.154 Mbytes +Step Time v_magnorm PotEng KinEng v_emag Temp TotEng + 0 0 0.010071723 -0.11868622 0 -0.12966919 0 -0.11868622 + 10 0.002 0.010030399 -0.37068593 0 -0.38171598 0 -0.37068593 + 20 0.004 0.0099889925 -0.6223216 0 -0.6334048 0 -0.6223216 + 30 0.006 0.0099474775 -0.87359358 0 -0.88473539 0 -0.87359358 + 40 0.008 0.0099058307 -1.1245034 0 -1.1357086 0 -1.1245034 + 50 0.01 0.0098640297 -1.3750538 0 -1.3863265 0 -1.3750538 + 60 0.012 0.0098220536 -1.6252482 0 -1.6365919 0 -1.6252482 + 70 0.014 0.0097798824 -1.8750914 0 -1.8865086 0 -1.8750914 + 80 0.016 0.0097374974 -2.1245886 0 -2.1360814 0 -2.1245886 + 90 0.018 0.0096948809 -2.3737458 0 -2.3853154 0 -2.3737458 + 100 0.02 0.009652016 -2.6225698 0 -2.6342168 0 -2.6225698 + 110 0.022 0.0096088867 -2.8710677 0 -2.8827919 0 -2.8710677 + 120 0.024 0.0095654777 -3.1192468 0 -3.1310475 0 -3.1192468 + 130 0.026 0.0095217747 -3.367115 0 -3.3789906 0 -3.367115 + 140 0.028 0.0094777639 -3.61468 0 -3.6266285 0 -3.61468 + 150 0.03 0.0094334324 -3.8619496 0 -3.8739683 0 -3.8619496 + 160 0.032 0.0093887681 -4.1089316 0 -4.1210173 0 -4.1089316 + 170 0.034 0.0093437598 -4.3556334 0 -4.3677824 0 -4.3556334 + 180 0.036 0.0092983974 -4.6020625 0 -4.6142704 0 -4.6020625 + 190 0.038 0.0092526719 -4.8482255 0 -4.8604877 0 -4.8482255 + 200 0.04 0.0092065757 -5.0941291 0 -5.1064403 0 -5.0941291 + 210 0.042 0.0091601026 -5.3397792 0 -5.3521339 0 -5.3397792 + 220 0.044 0.0091132479 -5.5851813 0 -5.5975736 0 -5.5851813 + 230 0.046 0.009066009 -5.8303404 0 -5.842764 0 -5.8303404 + 240 0.048 0.0090183848 -6.0752609 0 -6.0877092 0 -6.0752609 + 250 0.05 0.0089703766 -6.3199467 0 -6.3324129 0 -6.3199467 + 260 0.052 0.0089219875 -6.5644011 0 -6.5768782 0 -6.5644011 + 270 0.054 0.008873223 -6.808627 0 -6.8211078 0 -6.808627 + 280 0.056 0.0088240907 -7.0526266 0 -7.0651038 0 -7.0526266 + 290 0.058 0.0087746007 -7.296402 0 -7.3088682 0 -7.296402 + 300 0.06 0.0087247649 -7.5399545 0 -7.5524024 0 -7.5399545 + 310 0.062 0.0086745977 -7.7832854 0 -7.7957077 0 -7.7832854 + 320 0.064 0.0086241151 -8.0263956 0 -8.038785 0 -8.0263956 + 330 0.066 0.0085733351 -8.2692858 0 -8.281635 0 -8.2692858 + 340 0.068 0.0085222773 -8.5119564 0 -8.5242586 0 -8.5119564 + 350 0.07 0.0084709628 -8.7544078 0 -8.7666562 0 -8.7544078 + 360 0.072 0.0084194137 -8.9966403 0 -9.0088285 0 -8.9966403 + 370 0.074 0.0083676531 -9.2386543 0 -9.2507761 0 -9.2386543 + 380 0.076 0.0083157047 -9.4804501 0 -9.4924997 0 -9.4804501 + 390 0.078 0.0082635926 -9.7220281 0 -9.7340001 0 -9.7220281 + 400 0.08 0.0082113413 -9.9633888 0 -9.9752784 0 -9.9633888 + 410 0.082 0.0081589748 -10.204533 0 -10.216336 0 -10.204533 + 420 0.084 0.0081065174 -10.445462 0 -10.457173 0 -10.445462 + 430 0.086 0.0080539926 -10.686176 0 -10.697793 0 -10.686176 + 440 0.088 0.0080014236 -10.926676 0 -10.938197 0 -10.926676 + 450 0.09 0.007948833 -11.166966 0 -11.178387 0 -11.166966 + 460 0.092 0.0078962428 -11.407045 0 -11.418366 0 -11.407045 + 470 0.094 0.0078436745 -11.646917 0 -11.658136 0 -11.646917 + 480 0.096 0.0077911488 -11.886583 0 -11.8977 0 -11.886583 + 490 0.098 0.0077386861 -12.126047 0 -12.137063 0 -12.126047 + 500 0.1 0.0076863063 -12.365311 0 -12.376226 0 -12.365311 +Loop time of 19.2298 on 1 procs for 500 steps with 5780 atoms + +Performance: 0.449 ns/day, 53.416 hours/ns, 26.001 timesteps/s +99.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 | 5.2712 | 5.2712 | 5.2712 | 0.0 | 27.41 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.039467 | 0.039467 | 0.039467 | 0.0 | 0.21 +Output | 0.060013 | 0.060013 | 0.060013 | 0.0 | 0.31 +Modify | 13.82 | 13.82 | 13.82 | 0.0 | 71.87 +Other | | 0.03928 | | | 0.20 + +Nlocal: 5780 ave 5780 max 5780 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1065 ave 1065 max 1065 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: 92480 ave 92480 max 92480 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +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/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 new file mode 100644 index 0000000000..8e3990787a --- /dev/null +++ b/examples/SPIN/bfo/log.19Nov19.spin.bfo.g++.4 @@ -0,0 +1,167 @@ +LAMMPS (30 Oct 2019) +# layer sc iron atoms (in the [001] plane) in bismuth oxide + +units metal +atom_style spin +dimension 3 +boundary p p f + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.000843048 secs + +# setting mass, mag. moments, and interactions for bfo + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +#pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.1 21 +fix 3 all nve/spin lattice frozen + +timestep 0.0002 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +#thermo_style custom step time v_magnorm v_emag temp etotal +thermo_style custom step time v_magnorm pe ke v_emag temp etotal +thermo 10 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_bfo.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 500 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.744 | 7.744 | 7.744 Mbytes +Step Time v_magnorm PotEng KinEng v_emag Temp TotEng + 0 0 0.010071723 -0.11868622 0 -0.12966919 0 -0.11868622 + 10 0.002 0.010030399 -0.37068593 0 -0.38171598 0 -0.37068593 + 20 0.004 0.0099889925 -0.6223216 0 -0.6334048 0 -0.6223216 + 30 0.006 0.0099474775 -0.87359359 0 -0.8847354 0 -0.87359359 + 40 0.008 0.0099058307 -1.1245034 0 -1.1357086 0 -1.1245034 + 50 0.01 0.0098640297 -1.3750538 0 -1.3863265 0 -1.3750538 + 60 0.012 0.0098220535 -1.6252482 0 -1.6365919 0 -1.6252482 + 70 0.014 0.0097798823 -1.8750914 0 -1.8865086 0 -1.8750914 + 80 0.016 0.0097374973 -2.1245886 0 -2.1360814 0 -2.1245886 + 90 0.018 0.0096948808 -2.3737458 0 -2.3853155 0 -2.3737458 + 100 0.02 0.0096520159 -2.6225698 0 -2.6342168 0 -2.6225698 + 110 0.022 0.0096088866 -2.8710677 0 -2.8827919 0 -2.8710677 + 120 0.024 0.0095654776 -3.1192469 0 -3.1310475 0 -3.1192469 + 130 0.026 0.0095217746 -3.367115 0 -3.3789906 0 -3.367115 + 140 0.028 0.0094777638 -3.61468 0 -3.6266285 0 -3.61468 + 150 0.03 0.0094334323 -3.8619496 0 -3.8739683 0 -3.8619496 + 160 0.032 0.0093887679 -4.1089316 0 -4.1210173 0 -4.1089316 + 170 0.034 0.0093437596 -4.3556335 0 -4.3677824 0 -4.3556335 + 180 0.036 0.0092983972 -4.6020625 0 -4.6142704 0 -4.6020625 + 190 0.038 0.0092526717 -4.8482255 0 -4.8604877 0 -4.8482255 + 200 0.04 0.0092065755 -5.0941291 0 -5.1064403 0 -5.0941291 + 210 0.042 0.0091601024 -5.3397792 0 -5.3521339 0 -5.3397792 + 220 0.044 0.0091132478 -5.5851813 0 -5.5975736 0 -5.5851813 + 230 0.046 0.0090660089 -5.8303404 0 -5.842764 0 -5.8303404 + 240 0.048 0.0090183847 -6.0752609 0 -6.0877092 0 -6.0752609 + 250 0.05 0.0089703764 -6.3199467 0 -6.3324129 0 -6.3199467 + 260 0.052 0.0089219873 -6.5644011 0 -6.5768782 0 -6.5644011 + 270 0.054 0.0088732228 -6.808627 0 -6.8211078 0 -6.808627 + 280 0.056 0.0088240906 -7.0526266 0 -7.0651038 0 -7.0526266 + 290 0.058 0.0087746006 -7.296402 0 -7.3088682 0 -7.296402 + 300 0.06 0.0087247648 -7.5399545 0 -7.5524024 0 -7.5399545 + 310 0.062 0.0086745976 -7.7832854 0 -7.7957077 0 -7.7832854 + 320 0.064 0.0086241149 -8.0263956 0 -8.038785 0 -8.0263956 + 330 0.066 0.008573335 -8.2692858 0 -8.281635 0 -8.2692858 + 340 0.068 0.0085222772 -8.5119564 0 -8.5242586 0 -8.5119564 + 350 0.07 0.0084709627 -8.7544078 0 -8.7666562 0 -8.7544078 + 360 0.072 0.0084194136 -8.9966403 0 -9.0088285 0 -8.9966403 + 370 0.074 0.008367653 -9.2386543 0 -9.2507761 0 -9.2386543 + 380 0.076 0.0083157046 -9.4804501 0 -9.4924997 0 -9.4804501 + 390 0.078 0.0082635925 -9.7220281 0 -9.7340001 0 -9.7220281 + 400 0.08 0.0082113412 -9.9633888 0 -9.9752784 0 -9.9633888 + 410 0.082 0.0081589747 -10.204533 0 -10.216336 0 -10.204533 + 420 0.084 0.0081065173 -10.445462 0 -10.457173 0 -10.445462 + 430 0.086 0.0080539925 -10.686176 0 -10.697793 0 -10.686176 + 440 0.088 0.0080014235 -10.926676 0 -10.938197 0 -10.926676 + 450 0.09 0.0079488329 -11.166966 0 -11.178387 0 -11.166966 + 460 0.092 0.0078962427 -11.407045 0 -11.418366 0 -11.407045 + 470 0.094 0.0078436743 -11.646917 0 -11.658136 0 -11.646917 + 480 0.096 0.0077911486 -11.886583 0 -11.8977 0 -11.886583 + 490 0.098 0.007738686 -12.126047 0 -12.137063 0 -12.126047 + 500 0.1 0.0076863062 -12.365311 0 -12.376226 0 -12.365311 +Loop time of 5.69323 on 4 procs for 500 steps with 5780 atoms + +Performance: 1.518 ns/day, 15.815 hours/ns, 87.824 timesteps/s +99.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 | 1.2634 | 1.2866 | 1.3017 | 1.3 | 22.60 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.17396 | 0.18913 | 0.21531 | 3.6 | 3.32 +Output | 0.020815 | 0.021116 | 0.021569 | 0.2 | 0.37 +Modify | 4.1846 | 4.1875 | 4.1896 | 0.1 | 73.55 +Other | | 0.008815 | | | 0.15 + +Nlocal: 1445 ave 1445 max 1445 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 555 ave 555 max 555 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: 23120 ave 23120 max 23120 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:05 diff --git a/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.1 b/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.1 deleted file mode 100644 index d832b0001a..0000000000 --- a/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.1 +++ /dev/null @@ -1,142 +0,0 @@ -LAMMPS (11 May 2018) -# fcc cobalt in a 3d periodic box - -clear -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice fcc 3.54 -Lattice spacing in x,y,z = 3.54 3.54 3.54 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - Time spent = 0.000651121 secs - -# setting mass, mag. moments, and interactions for fcc cobalt - -mass 1 58.93 - -#set group all spin/random 31 1.72 -set group all spin 1.72 0.0 0.0 1.0 - 500 settings made for spin -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 -fix_modify 1 energy yes - -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -thermo_style custom f_1 - -variable magx equal c_out_mag[1] -variable magy equal c_out_mag[2] -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time f_1 v_magx v_magy v_magnorm v_emag temp etotal -thermo 50 - -#compute outsp all property/atom spx spy spz sp fmx fmy fmz -#dump 100 all custom 1 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 1000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.59954 - ghost atom cutoff = 6.59954 - binsize = 3.29977, bins = 6 6 6 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 5.218 | 5.218 | 5.218 Mbytes -Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng - 0 0 0.049785486 0 0 1 -187.94116 100.00543 -2372.4636 - 50 0.005 0.049785486 0 0 1 -187.94112 95.094679 -2372.4636 - 100 0.01 0.049785486 0 0 1 -187.94071 81.578321 -2372.4636 - 150 0.015 0.049785486 0 0 1 -187.93912 62.802727 -2372.4636 - 200 0.02 0.049785486 0 0 1 -187.93551 43.35108 -2372.4636 - 250 0.025 0.049785486 0 0 1 -187.92942 27.749821 -2372.4636 - 300 0.03 0.049785486 0 0 1 -187.92118 19.149389 -2372.4636 - 350 0.035 0.049785486 0 0 1 -187.91199 18.453387 -2372.4636 - 400 0.04 0.049785486 0 0 1 -187.90364 24.249423 -2372.4636 - 450 0.045 0.049785486 0 0 1 -187.89806 33.548008 -2372.4636 - 500 0.05 0.049785486 0 0 1 -187.89668 42.973172 -2372.4636 - 550 0.055 0.049785486 0 0 1 -187.9 49.902539 -2372.4636 - 600 0.06 0.049785486 0 0 1 -187.90735 53.166772 -2372.4636 - 650 0.065 0.049785486 0 0 1 -187.91706 53.153416 -2372.4636 - 700 0.07 0.049785486 0 0 1 -187.92692 51.377187 -2372.4636 - 750 0.075 0.049785486 0 0 1 -187.9348 49.725449 -2372.4636 - 800 0.08 0.049785486 0 0 1 -187.93921 49.663576 -2372.4636 - 850 0.085 0.049785486 0 0 1 -187.93974 51.681567 -2372.4636 - 900 0.09 0.049785486 0 0 1 -187.937 55.166554 -2372.4636 - 950 0.095 0.049785486 0 0 1 -187.93239 58.718232 -2372.4636 - 1000 0.1 0.049785486 0 0 1 -187.92755 60.75567 -2372.4636 -Loop time of 4.1303 on 1 procs for 1000 steps with 500 atoms - -Performance: 2.092 ns/day, 11.473 hours/ns, 242.113 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 | 2.142 | 2.142 | 2.142 | 0.0 | 51.86 -Neigh | 0.0094573 | 0.0094573 | 0.0094573 | 0.0 | 0.23 -Comm | 0.023293 | 0.023293 | 0.023293 | 0.0 | 0.56 -Output | 0.00031972 | 0.00031972 | 0.00031972 | 0.0 | 0.01 -Modify | 1.9488 | 1.9488 | 1.9488 | 0.0 | 47.18 -Other | | 0.006488 | | | 0.16 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1956 ave 1956 max 1956 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 24065 ave 24065 max 24065 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 48130 ave 48130 max 48130 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 48130 -Ave neighs/atom = 96.26 -Neighbor list builds = 6 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:04 diff --git a/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.4 b/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.4 deleted file mode 100644 index 358d7cfc7a..0000000000 --- a/examples/SPIN/cobalt_fcc/log.11May18.spin.cobalt_fcc.g++.4 +++ /dev/null @@ -1,142 +0,0 @@ -LAMMPS (11 May 2018) -# fcc cobalt in a 3d periodic box - -clear -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice fcc 3.54 -Lattice spacing in x,y,z = 3.54 3.54 3.54 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - Time spent = 0.000240088 secs - -# setting mass, mag. moments, and interactions for fcc cobalt - -mass 1 58.93 - -#set group all spin/random 31 1.72 -set group all spin 1.72 0.0 0.0 1.0 - 500 settings made for spin -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 -fix_modify 1 energy yes - -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -thermo_style custom f_1 - -variable magx equal c_out_mag[1] -variable magy equal c_out_mag[2] -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time f_1 v_magx v_magy v_magnorm v_emag temp etotal -thermo 50 - -#compute outsp all property/atom spx spy spz sp fmx fmy fmz -#dump 100 all custom 1 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 1000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.59954 - ghost atom cutoff = 6.59954 - binsize = 3.29977, bins = 6 6 6 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 5.163 | 5.163 | 5.163 Mbytes -Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng - 0 0 0.049785486 0 0 1 -187.94116 100.00543 -2372.4636 - 50 0.005 0.049785486 0 0 1 -187.94101 95.174807 -2372.4636 - 100 0.01 0.049785486 0 0 1 -187.94029 81.854304 -2372.4636 - 150 0.015 0.049785486 0 0 1 -187.93834 63.270938 -2372.4636 - 200 0.02 0.049785486 0 0 1 -187.93446 43.867262 -2372.4636 - 250 0.025 0.049785486 0 0 1 -187.92831 28.075261 -2372.4636 - 300 0.03 0.049785486 0 0 1 -187.92031 19.046222 -2372.4636 - 350 0.035 0.049785486 0 0 1 -187.91161 17.79071 -2372.4636 - 400 0.04 0.049785486 0 0 1 -187.9039 23.079994 -2372.4636 - 450 0.045 0.049785486 0 0 1 -187.89895 32.127316 -2372.4636 - 500 0.05 0.049785486 0 0 1 -187.89801 41.709644 -2372.4636 - 550 0.055 0.049785486 0 0 1 -187.90146 49.246292 -2372.4636 - 600 0.06 0.049785486 0 0 1 -187.90859 53.465535 -2372.4636 - 650 0.065 0.049785486 0 0 1 -187.91778 54.522857 -2372.4636 - 700 0.07 0.049785486 0 0 1 -187.9269 53.635521 -2372.4636 - 750 0.075 0.049785486 0 0 1 -187.93396 52.419678 -2372.4636 - 800 0.08 0.049785486 0 0 1 -187.9376 52.176558 -2372.4636 - 850 0.085 0.049785486 0 0 1 -187.93744 53.380592 -2372.4636 - 900 0.09 0.049785486 0 0 1 -187.93412 55.551378 -2372.4636 - 950 0.095 0.049785486 0 0 1 -187.92902 57.540047 -2372.4636 - 1000 0.1 0.049785486 0 0 1 -187.92378 58.088674 -2372.4636 -Loop time of 1.71411 on 4 procs for 1000 steps with 500 atoms - -Performance: 5.041 ns/day, 4.761 hours/ns, 583.392 timesteps/s -97.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.54717 | 0.57392 | 0.58784 | 2.1 | 33.48 -Neigh | 0.0023484 | 0.0025793 | 0.0026793 | 0.3 | 0.15 -Comm | 0.058548 | 0.073335 | 0.10006 | 5.9 | 4.28 -Output | 0.00042272 | 0.00079203 | 0.0018559 | 0.0 | 0.05 -Modify | 1.0577 | 1.0611 | 1.0625 | 0.2 | 61.90 -Other | | 0.00239 | | | 0.14 - -Nlocal: 125 ave 133 max 116 min -Histogram: 1 0 0 0 0 2 0 0 0 1 -Nghost: 1099 ave 1108 max 1091 min -Histogram: 1 0 0 0 2 0 0 0 0 1 -Neighs: 6032.5 ave 6417 max 5489 min -Histogram: 1 0 0 0 0 0 1 1 0 1 -FullNghs: 12065 ave 13062 max 10970 min -Histogram: 1 0 0 0 0 2 0 0 0 1 - -Total # of neighbors = 48260 -Ave neighs/atom = 96.52 -Neighbor list builds = 6 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:01 diff --git a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 new file mode 100644 index 0000000000..fb95d9ab48 --- /dev/null +++ b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.1 @@ -0,0 +1,142 @@ +LAMMPS (30 Oct 2019) +# fcc cobalt in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice fcc 3.54 +Lattice spacing in x,y,z = 3.54 3.54 3.54 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.00110412 secs + +# setting mass, mag. moments, and interactions for fcc cobalt + +mass 1 58.93 + +#set group all spin/random 31 1.72 +set group all spin 1.72 0.0 0.0 1.0 + 500 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 +fix_modify 1 energy yes + +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +thermo_style custom f_1 + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time f_1 v_magx v_magy v_magnorm v_emag temp etotal +thermo 50 + +# compute outsp all property/atom spx spy spz sp fmx fmy fmz +# dump 1 all custom 100 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.59954 + ghost atom cutoff = 6.59954 + binsize = 3.29977, bins = 6 6 6 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 5.718 | 5.718 | 5.718 Mbytes +Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng + 0 0 -0.099570972 0 0 1 -188.09051 100.00543 -2372.6129 + 50 0.005 -0.099570972 0 0 1 -188.09048 95.094679 -2372.6129 + 100 0.01 -0.099570972 0 0 1 -188.09007 81.578321 -2372.6129 + 150 0.015 -0.099570972 0 0 1 -188.08848 62.802727 -2372.6129 + 200 0.02 -0.099570972 0 0 1 -188.08487 43.35108 -2372.6129 + 250 0.025 -0.099570972 0 0 1 -188.07877 27.749821 -2372.6129 + 300 0.03 -0.099570972 0 0 1 -188.07054 19.149389 -2372.6129 + 350 0.035 -0.099570972 0 0 1 -188.06135 18.453387 -2372.6129 + 400 0.04 -0.099570972 0 0 1 -188.053 24.249423 -2372.6129 + 450 0.045 -0.099570972 0 0 1 -188.04742 33.548008 -2372.6129 + 500 0.05 -0.099570972 0 0 1 -188.04604 42.973172 -2372.6129 + 550 0.055 -0.099570972 0 0 1 -188.04935 49.902539 -2372.6129 + 600 0.06 -0.099570972 0 0 1 -188.0567 53.166772 -2372.6129 + 650 0.065 -0.099570972 0 0 1 -188.06642 53.153416 -2372.6129 + 700 0.07 -0.099570972 0 0 1 -188.07628 51.377187 -2372.6129 + 750 0.075 -0.099570972 0 0 1 -188.08415 49.725449 -2372.6129 + 800 0.08 -0.099570972 0 0 1 -188.08857 49.663576 -2372.6129 + 850 0.085 -0.099570972 0 0 1 -188.0891 51.681567 -2372.6129 + 900 0.09 -0.099570972 0 0 1 -188.08636 55.166554 -2372.6129 + 950 0.095 -0.099570972 0 0 1 -188.08174 58.718232 -2372.6129 + 1000 0.1 -0.099570972 0 0 1 -188.0769 60.75567 -2372.6129 +Loop time of 5.66302 on 1 procs for 1000 steps with 500 atoms + +Performance: 1.526 ns/day, 15.731 hours/ns, 176.584 timesteps/s +100.0% 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.8546 | 2.8546 | 2.8546 | 0.0 | 50.41 +Neigh | 0.012496 | 0.012496 | 0.012496 | 0.0 | 0.22 +Comm | 0.041981 | 0.041981 | 0.041981 | 0.0 | 0.74 +Output | 0.0014014 | 0.0014014 | 0.0014014 | 0.0 | 0.02 +Modify | 2.7441 | 2.7441 | 2.7441 | 0.0 | 48.46 +Other | | 0.008486 | | | 0.15 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 24065 ave 24065 max 24065 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 48130 ave 48130 max 48130 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 48130 +Ave neighs/atom = 96.26 +Neighbor list builds = 6 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:05 diff --git a/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 new file mode 100644 index 0000000000..6d8e74f37f --- /dev/null +++ b/examples/SPIN/cobalt_fcc/log.19Nov19.spin.cobalt_fcc.g++.4 @@ -0,0 +1,142 @@ +LAMMPS (30 Oct 2019) +# fcc cobalt in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice fcc 3.54 +Lattice spacing in x,y,z = 3.54 3.54 3.54 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (17.7 17.7 17.7) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.00073719 secs + +# setting mass, mag. moments, and interactions for fcc cobalt + +mass 1 58.93 + +#set group all spin/random 31 1.72 +set group all spin 1.72 0.0 0.0 1.0 + 500 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 +fix_modify 1 energy yes + +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +thermo_style custom f_1 + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time f_1 v_magx v_magy v_magnorm v_emag temp etotal +thermo 50 + +# compute outsp all property/atom spx spy spz sp fmx fmy fmz +# dump 1 all custom 100 dump_cobalt_fcc.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.59954 + ghost atom cutoff = 6.59954 + binsize = 3.29977, bins = 6 6 6 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 5.664 | 5.664 | 5.664 Mbytes +Step Time f_1 v_magx v_magy v_magnorm v_emag Temp TotEng + 0 0 -0.099570972 0 0 1 -188.09051 100.00543 -2372.6129 + 50 0.005 -0.099570972 0 0 1 -188.09036 95.174807 -2372.6129 + 100 0.01 -0.099570972 0 0 1 -188.08965 81.854304 -2372.6129 + 150 0.015 -0.099570972 0 0 1 -188.0877 63.270938 -2372.6129 + 200 0.02 -0.099570972 0 0 1 -188.08381 43.867262 -2372.6129 + 250 0.025 -0.099570972 0 0 1 -188.07767 28.075261 -2372.6129 + 300 0.03 -0.099570972 0 0 1 -188.06966 19.046222 -2372.6129 + 350 0.035 -0.099570972 0 0 1 -188.06096 17.79071 -2372.6129 + 400 0.04 -0.099570972 0 0 1 -188.05326 23.079994 -2372.6129 + 450 0.045 -0.099570972 0 0 1 -188.04831 32.127316 -2372.6129 + 500 0.05 -0.099570972 0 0 1 -188.04737 41.709644 -2372.6129 + 550 0.055 -0.099570972 0 0 1 -188.05082 49.246292 -2372.6129 + 600 0.06 -0.099570972 0 0 1 -188.05795 53.465535 -2372.6129 + 650 0.065 -0.099570972 0 0 1 -188.06713 54.522857 -2372.6129 + 700 0.07 -0.099570972 0 0 1 -188.07626 53.635521 -2372.6129 + 750 0.075 -0.099570972 0 0 1 -188.08332 52.419678 -2372.6129 + 800 0.08 -0.099570972 0 0 1 -188.08696 52.176558 -2372.6129 + 850 0.085 -0.099570972 0 0 1 -188.0868 53.380592 -2372.6129 + 900 0.09 -0.099570972 0 0 1 -188.08348 55.551378 -2372.6129 + 950 0.095 -0.099570972 0 0 1 -188.07838 57.540047 -2372.6129 + 1000 0.1 -0.099570972 0 0 1 -188.07314 58.088674 -2372.6129 +Loop time of 3.36398 on 4 procs for 1000 steps with 500 atoms + +Performance: 2.568 ns/day, 9.344 hours/ns, 297.267 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 | 0.67186 | 0.78327 | 0.87877 | 8.5 | 23.28 +Neigh | 0.0027554 | 0.0033352 | 0.0038562 | 0.7 | 0.10 +Comm | 0.20661 | 0.30174 | 0.41594 | 14.1 | 8.97 +Output | 0.0007627 | 0.00084305 | 0.0010374 | 0.0 | 0.03 +Modify | 2.2674 | 2.2712 | 2.2779 | 0.3 | 67.52 +Other | | 0.003571 | | | 0.11 + +Nlocal: 125 ave 133 max 116 min +Histogram: 1 0 0 0 0 2 0 0 0 1 +Nghost: 1099 ave 1108 max 1091 min +Histogram: 1 0 0 0 2 0 0 0 0 1 +Neighs: 6032.5 ave 6417 max 5489 min +Histogram: 1 0 0 0 0 0 1 1 0 1 +FullNghs: 12065 ave 13062 max 10970 min +Histogram: 1 0 0 0 0 2 0 0 0 1 + +Total # of neighbors = 48260 +Ave neighs/atom = 96.52 +Neighbor list builds = 6 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:03 diff --git a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp index e5a49cd336..dd114202cb 100644 --- a/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp +++ b/examples/SPIN/cobalt_hcp/in.spin.cobalt_hcp @@ -57,4 +57,4 @@ thermo 10 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 20000 +run 1000 diff --git a/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.1 b/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.1 deleted file mode 100644 index 4bb513de18..0000000000 --- a/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.1 +++ /dev/null @@ -1,318 +0,0 @@ -LAMMPS (11 May 2018) -# hcp cobalt in a 3d periodic box - -clear -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice hcp 2.5071 -Lattice spacing in x,y,z = 2.5071 4.34242 4.09408 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - Time spent = 0.000801802 secs - -# setting mass, mag. moments, and interactions for hcp cobalt - -mass 1 58.93 - -#set group all spin/random 31 1.72 -set group all spin 1.72 0.0 0.0 1.0 - 500 settings made for spin -velocity all create 100 4928459 rot yes dist gaussian - -#pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.3593 1.135028015e-05 1.064568567 -#pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 - - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes - -timestep 0.0001 - - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp etotal -thermo 10 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 2000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.59954 - ghost atom cutoff = 6.59954 - binsize = 3.29977, bins = 4 7 7 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.401 | 7.401 | 7.401 Mbytes -Step Time v_magnorm v_emag Temp TotEng - 0 0 1 -187.29499 100.00543 -2375.8943 - 10 0.001 1 -187.29714 99.845593 -2375.8943 - 20 0.002 1 -187.30356 99.367234 -2375.8943 - 30 0.003 1 -187.31419 98.573996 -2375.8943 - 40 0.004 1 -187.32896 97.472027 -2375.8943 - 50 0.005 1 -187.34772 96.069944 -2375.8943 - 60 0.006 1 -187.37032 94.378764 -2375.8943 - 70 0.007 1 -187.39656 92.411827 -2375.8943 - 80 0.008 1 -187.4262 90.184697 -2375.8943 - 90 0.009 1 -187.459 87.715037 -2375.8943 - 100 0.01 1 -187.49466 85.022479 -2375.8943 - 110 0.011 1 -187.53289 82.128462 -2375.8943 - 120 0.012 1 -187.57334 79.05606 -2375.8943 - 130 0.013 1 -187.61568 75.82979 -2375.8943 - 140 0.014 1 -187.65953 72.475403 -2375.8943 - 150 0.015 1 -187.70453 69.019658 -2375.8943 - 160 0.016 1 -187.75028 65.490086 -2375.8943 - 170 0.017 1 -187.79642 61.914735 -2375.8943 - 180 0.018 1 -187.84254 58.321911 -2375.8943 - 190 0.019 1 -187.88828 54.739907 -2375.8943 - 200 0.02 1 -187.93324 51.196728 -2375.8943 - 210 0.021 1 -187.97708 47.719812 -2375.8943 - 220 0.022 1 -188.01947 44.335762 -2375.8943 - 230 0.023 1 -188.06003 41.07007 -2375.8943 - 240 0.024 1 -188.09853 37.946852 -2375.8944 - 250 0.025 1 -188.13457 34.988599 -2375.8944 - 260 0.026 1 -188.16795 32.215943 -2375.8944 - 270 0.027 1 -188.19851 29.647465 -2375.8944 - 280 0.028 1 -188.22593 27.299481 -2375.8944 - 290 0.029 1 -188.25011 25.185896 -2375.8944 - 300 0.03 1 -188.27095 23.318075 -2375.8945 - 310 0.031 1 -188.2883 21.70475 -2375.8945 - 320 0.032 1 -188.30213 20.35194 -2375.8945 - 330 0.033 1 -188.31251 19.262946 -2375.8945 - 340 0.034 1 -188.31928 18.438347 -2375.8945 - 350 0.035 1 -188.32258 17.876036 -2375.8945 - 360 0.036 1 -188.32249 17.571322 -2375.8945 - 370 0.037 1 -188.31913 17.517032 -2375.8945 - 380 0.038 1 -188.31264 17.703653 -2375.8945 - 390 0.039 1 -188.30321 18.119513 -2375.8945 - 400 0.04 1 -188.29102 18.750969 -2375.8945 - 410 0.041 1 -188.2763 19.582631 -2375.8945 - 420 0.042 1 -188.25929 20.597597 -2375.8945 - 430 0.043 1 -188.24025 21.777699 -2375.8945 - 440 0.044 1 -188.21945 23.103765 -2375.8945 - 450 0.045 1 -188.19719 24.555878 -2375.8946 - 460 0.046 1 -188.17368 26.113643 -2375.8946 - 470 0.047 1 -188.1493 27.756439 -2375.8946 - 480 0.048 1 -188.12429 29.463677 -2375.8946 - 490 0.049 1 -188.09895 31.21504 -2375.8946 - 500 0.05 1 -188.07354 32.990713 -2375.8946 - 510 0.051 1 -188.04832 34.771601 -2375.8945 - 520 0.052 1 -188.02358 36.539517 -2375.8945 - 530 0.053 1 -187.99951 38.27736 -2375.8945 - 540 0.054 1 -187.97636 39.969275 -2375.8945 - 550 0.055 1 -187.95437 41.600775 -2375.8945 - 560 0.056 1 -187.93364 43.158863 -2375.8944 - 570 0.057 1 -187.9144 44.632119 -2375.8944 - 580 0.058 1 -187.89669 46.010765 -2375.8944 - 590 0.059 1 -187.88074 47.286714 -2375.8944 - 600 0.06 1 -187.86658 48.453573 -2375.8944 - 610 0.061 1 -187.85422 49.506668 -2375.8943 - 620 0.062 1 -187.84377 50.443021 -2375.8943 - 630 0.063 1 -187.8352 51.261297 -2375.8943 - 640 0.064 1 -187.8285 51.961764 -2375.8943 - 650 0.065 1 -187.8236 52.54622 -2375.8943 - 660 0.066 1 -187.8205 53.017899 -2375.8943 - 670 0.067 1 -187.81909 53.381374 -2375.8943 - 680 0.068 1 -187.81926 53.64244 -2375.8943 - 690 0.069 1 -187.82092 53.807997 -2375.8943 - 700 0.07 1 -187.82391 53.885909 -2375.8943 - 710 0.071 1 -187.82814 53.884865 -2375.8943 - 720 0.072 1 -187.83339 53.814238 -2375.8943 - 730 0.073 1 -187.83952 53.68392 -2375.8943 - 740 0.074 1 -187.84635 53.504185 -2375.8943 - 750 0.075 1 -187.85375 53.285525 -2375.8943 - 760 0.076 1 -187.86153 53.038494 -2375.8943 - 770 0.077 1 -187.86952 52.773567 -2375.8943 - 780 0.078 1 -187.87758 52.500994 -2375.8943 - 790 0.079 1 -187.88549 52.230655 -2375.8943 - 800 0.08 1 -187.89313 51.971933 -2375.8943 - 810 0.081 1 -187.90035 51.733593 -2375.8943 - 820 0.082 1 -187.90702 51.523671 -2375.8943 - 830 0.083 1 -187.91302 51.349376 -2375.8943 - 840 0.084 1 -187.91824 51.217006 -2375.8943 - 850 0.085 1 -187.9226 51.131875 -2375.8943 - 860 0.086 1 -187.92602 51.098259 -2375.8943 - 870 0.087 1 -187.92844 51.119356 -2375.8943 - 880 0.088 1 -187.92979 51.197261 -2375.8943 - 890 0.089 1 -187.93011 51.332955 -2375.8943 - 900 0.09 1 -187.92937 51.526314 -2375.8943 - 910 0.091 1 -187.92757 51.77613 -2375.8943 - 920 0.092 1 -187.92475 52.080145 -2375.8943 - 930 0.093 1 -187.92096 52.435106 -2375.8943 - 940 0.094 1 -187.91624 52.836825 -2375.8943 - 950 0.095 1 -187.91068 53.280251 -2375.8943 - 960 0.096 1 -187.90435 53.759559 -2375.8943 - 970 0.097 1 -187.89734 54.268246 -2375.8943 - 980 0.098 1 -187.88981 54.799223 -2375.8943 - 990 0.099 1 -187.88185 55.344928 -2375.8943 - 1000 0.1 1 -187.87357 55.897438 -2375.8943 - 1010 0.101 1 -187.86511 56.448585 -2375.8943 - 1020 0.102 1 -187.8566 56.990069 -2375.8943 - 1030 0.103 1 -187.84817 57.513575 -2375.8943 - 1040 0.104 1 -187.83995 58.010887 -2375.8943 - 1050 0.105 1 -187.83208 58.474004 -2375.8943 - 1060 0.106 1 -187.8247 58.89524 -2375.8943 - 1070 0.107 1 -187.81789 59.267328 -2375.8943 - 1080 0.108 1 -187.81177 59.583518 -2375.8943 - 1090 0.109 1 -187.80646 59.837665 -2375.8943 - 1100 0.11 1 -187.80204 60.024306 -2375.8943 - 1110 0.111 1 -187.79861 60.138734 -2375.8943 - 1120 0.112 1 -187.79625 60.177056 -2375.8943 - 1130 0.113 1 -187.79497 60.136244 -2375.8943 - 1140 0.114 1 -187.79485 60.014176 -2375.8943 - 1150 0.115 1 -187.7959 59.809665 -2375.8943 - 1160 0.116 1 -187.79811 59.52248 -2375.8943 - 1170 0.117 1 -187.80157 59.153353 -2375.8943 - 1180 0.118 1 -187.80618 58.703971 -2375.8943 - 1190 0.119 1 -187.81193 58.176956 -2375.8943 - 1200 0.12 1 -187.81879 57.575849 -2375.8943 - 1210 0.121 1 -187.82668 56.905072 -2375.8943 - 1220 0.122 1 -187.83554 56.169878 -2375.8943 - 1230 0.123 1 -187.84528 55.376297 -2375.8943 - 1240 0.124 1 -187.85581 54.53107 -2375.8943 - 1250 0.125 1 -187.86702 53.641573 -2375.8943 - 1260 0.126 1 -187.8788 52.715739 -2375.8943 - 1270 0.127 1 -187.89103 51.761969 -2375.8943 - 1280 0.128 1 -187.90358 50.789036 -2375.8943 - 1290 0.129 1 -187.91632 49.805988 -2375.8943 - 1300 0.13 1 -187.92911 48.822045 -2375.8943 - 1310 0.131 1 -187.94182 47.846491 -2375.8943 - 1320 0.132 1 -187.95428 46.888574 -2375.8943 - 1330 0.133 1 -187.96643 45.957394 -2375.8943 - 1340 0.134 1 -187.9781 45.061794 -2375.8943 - 1350 0.135 1 -187.9892 44.210263 -2375.8943 - 1360 0.136 1 -187.99955 43.410832 -2375.8943 - 1370 0.137 1 -188.00907 42.670979 -2375.8943 - 1380 0.138 1 -188.01767 41.997547 -2375.8943 - 1390 0.139 1 -188.02525 41.396655 -2375.8943 - 1400 0.14 1 -188.03177 40.873631 -2375.8944 - 1410 0.141 1 -188.03711 40.432952 -2375.8944 - 1420 0.142 1 -188.04124 40.078172 -2375.8944 - 1430 0.143 1 -188.04413 39.811902 -2375.8944 - 1440 0.144 1 -188.04575 39.635775 -2375.8944 - 1450 0.145 1 -188.04607 39.550435 -2375.8943 - 1460 0.146 1 -188.04515 39.555512 -2375.8943 - 1470 0.147 1 -188.04298 39.649651 -2375.8943 - 1480 0.148 1 -188.03961 39.830523 -2375.8943 - 1490 0.149 1 -188.03508 40.094865 -2375.8943 - 1500 0.15 1 -188.02944 40.438519 -2375.8943 - 1510 0.151 1 -188.02275 40.856491 -2375.8943 - 1520 0.152 1 -188.01515 41.343019 -2375.8943 - 1530 0.153 1 -188.00671 41.891643 -2375.8943 - 1540 0.154 1 -187.99753 42.495295 -2375.8943 - 1550 0.155 1 -187.98772 43.14639 -2375.8943 - 1560 0.156 1 -187.9774 43.836918 -2375.8943 - 1570 0.157 1 -187.9667 44.558553 -2375.8943 - 1580 0.158 1 -187.95576 45.302751 -2375.8943 - 1590 0.159 1 -187.94466 46.060862 -2375.8943 - 1600 0.16 1 -187.93356 46.824226 -2375.8943 - 1610 0.161 1 -187.92257 47.584289 -2375.8943 - 1620 0.162 1 -187.91183 48.332703 -2375.8943 - 1630 0.163 1 -187.90145 49.061422 -2375.8943 - 1640 0.164 1 -187.89155 49.762798 -2375.8943 - 1650 0.165 1 -187.88222 50.429671 -2375.8943 - 1660 0.166 1 -187.87357 51.055445 -2375.8943 - 1670 0.167 1 -187.86569 51.634167 -2375.8943 - 1680 0.168 1 -187.85864 52.160588 -2375.8943 - 1690 0.169 1 -187.85249 52.630219 -2375.8943 - 1700 0.17 1 -187.8473 53.039377 -2375.8943 - 1710 0.171 1 -187.84311 53.385221 -2375.8943 - 1720 0.172 1 -187.83994 53.665778 -2375.8943 - 1730 0.173 1 -187.83781 53.879954 -2375.8943 - 1740 0.174 1 -187.83671 54.027539 -2375.8943 - 1750 0.175 1 -187.83663 54.109201 -2375.8943 - 1760 0.176 1 -187.83753 54.126472 -2375.8943 - 1770 0.177 1 -187.83941 54.081708 -2375.8943 - 1780 0.178 1 -187.8422 53.97806 -2375.8943 - 1790 0.179 1 -187.84584 53.819424 -2375.8943 - 1800 0.18 1 -187.85025 53.610389 -2375.8943 - 1810 0.181 1 -187.85535 53.356163 -2375.8943 - 1820 0.182 1 -187.86105 53.06251 -2375.8943 - 1830 0.183 1 -187.86723 52.735671 -2375.8943 - 1840 0.184 1 -187.87384 52.382262 -2375.8943 - 1850 0.185 1 -187.88075 52.009201 -2375.8943 - 1860 0.186 1 -187.88784 51.623613 -2375.8943 - 1870 0.187 1 -187.89501 51.232726 -2375.8943 - 1880 0.188 1 -187.90214 50.843782 -2375.8943 - 1890 0.189 1 -187.90912 50.463929 -2375.8943 - 1900 0.19 1 -187.91585 50.100133 -2375.8943 - 1910 0.191 1 -187.92222 49.759075 -2375.8943 - 1920 0.192 1 -187.92814 49.447064 -2375.8943 - 1930 0.193 1 -187.93351 49.169949 -2375.8943 - 1940 0.194 1 -187.93826 48.933036 -2375.8943 - 1950 0.195 1 -187.94232 48.741013 -2375.8943 - 1960 0.196 1 -187.94561 48.597888 -2375.8943 - 1970 0.197 1 -187.94809 48.506926 -2375.8943 - 1980 0.198 1 -187.94972 48.470605 -2375.8943 - 1990 0.199 1 -187.95047 48.490576 -2375.8943 - 2000 0.2 1 -187.95033 48.567643 -2375.8943 -Loop time of 10.5391 on 1 procs for 2000 steps with 500 atoms - -Performance: 1.640 ns/day, 14.638 hours/ns, 189.770 timesteps/s -99.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 | 4.9958 | 4.9958 | 4.9958 | 0.0 | 47.40 -Neigh | 0.020741 | 0.020741 | 0.020741 | 0.0 | 0.20 -Comm | 0.05899 | 0.05899 | 0.05899 | 0.0 | 0.56 -Output | 1.1598 | 1.1598 | 1.1598 | 0.0 | 11.00 -Modify | 4.2885 | 4.2885 | 4.2885 | 0.0 | 40.69 -Other | | 0.01522 | | | 0.14 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 2444 ave 2444 max 2444 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 27041 ave 27041 max 27041 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 54082 ave 54082 max 54082 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 54082 -Ave neighs/atom = 108.164 -Neighbor list builds = 12 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:10 diff --git a/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.4 b/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.4 deleted file mode 100644 index 4e7e6b1b97..0000000000 --- a/examples/SPIN/cobalt_hcp/log.11May18.spin.cobalt_hcp.g++.4 +++ /dev/null @@ -1,318 +0,0 @@ -LAMMPS (11 May 2018) -# hcp cobalt in a 3d periodic box - -clear -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice hcp 2.5071 -Lattice spacing in x,y,z = 2.5071 4.34242 4.09408 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - Time spent = 0.000241518 secs - -# setting mass, mag. moments, and interactions for hcp cobalt - -mass 1 58.93 - -#set group all spin/random 31 1.72 -set group all spin 1.72 0.0 0.0 1.0 - 500 settings made for spin -velocity all create 100 4928459 rot yes dist gaussian - -#pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.3593 1.135028015e-05 1.064568567 -#pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 - - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes - -timestep 0.0001 - - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp etotal -thermo 10 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 2000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 6.59954 - ghost atom cutoff = 6.59954 - binsize = 3.29977, bins = 4 7 7 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.313 | 7.314 | 7.314 Mbytes -Step Time v_magnorm v_emag Temp TotEng - 0 0 1 -187.29499 100.00543 -2375.8943 - 10 0.001 1 -187.29721 99.841045 -2375.8943 - 20 0.002 1 -187.30385 99.349208 -2375.8943 - 30 0.003 1 -187.31485 98.533905 -2375.8943 - 40 0.004 1 -187.33011 97.401749 -2375.8943 - 50 0.005 1 -187.34949 95.961938 -2375.8943 - 60 0.006 1 -187.37283 94.22618 -2375.8943 - 70 0.007 1 -187.39992 92.208606 -2375.8943 - 80 0.008 1 -187.43051 89.92566 -2375.8943 - 90 0.009 1 -187.46434 87.39597 -2375.8943 - 100 0.01 1 -187.5011 84.640195 -2375.8943 - 110 0.011 1 -187.54047 81.680862 -2375.8943 - 120 0.012 1 -187.5821 78.542172 -2375.8943 - 130 0.013 1 -187.62564 75.249797 -2375.8943 - 140 0.014 1 -187.67069 71.830656 -2375.8943 - 150 0.015 1 -187.71686 68.312673 -2375.8943 - 160 0.016 1 -187.76377 64.724523 -2375.8943 - 170 0.017 1 -187.81099 61.095365 -2375.8943 - 180 0.018 1 -187.85814 57.454566 -2375.8943 - 190 0.019 1 -187.90481 53.831412 -2375.8943 - 200 0.02 1 -187.95061 50.254822 -2375.8943 - 210 0.021 1 -187.99517 46.753056 -2375.8943 - 220 0.022 1 -188.03812 43.353428 -2375.8943 - 230 0.023 1 -188.07913 40.082023 -2375.8943 - 240 0.024 1 -188.11787 36.963429 -2375.8943 - 250 0.025 1 -188.15409 34.020481 -2375.8943 - 260 0.026 1 -188.1875 31.27403 -2375.8943 - 270 0.027 1 -188.21782 28.74271 -2375.8943 - 280 0.028 1 -188.2449 26.44276 -2375.8943 - 290 0.029 1 -188.26857 24.387875 -2375.8943 - 300 0.03 1 -188.28877 22.589076 -2375.8944 - 310 0.031 1 -188.30529 21.054615 -2375.8944 - 320 0.032 1 -188.31814 19.789913 -2375.8944 - 330 0.033 1 -188.3273 18.797563 -2375.8944 - 340 0.034 1 -188.33284 18.077336 -2375.8944 - 350 0.035 1 -188.33478 17.626237 -2375.8945 - 360 0.036 1 -188.33319 17.438611 -2375.8945 - 370 0.037 1 -188.32824 17.506247 -2375.8945 - 380 0.038 1 -188.32007 17.818564 -2375.8945 - 390 0.039 1 -188.30888 18.362769 -2375.8945 - 400 0.04 1 -188.2949 19.124086 -2375.8945 - 410 0.041 1 -188.27837 20.085983 -2375.8945 - 420 0.042 1 -188.25957 21.230423 -2375.8945 - 430 0.043 1 -188.23868 22.538112 -2375.8945 - 440 0.044 1 -188.21604 23.988778 -2375.8945 - 450 0.045 1 -188.19195 25.561447 -2375.8945 - 460 0.046 1 -188.16672 27.234703 -2375.8945 - 470 0.047 1 -188.14064 28.986964 -2375.8946 - 480 0.048 1 -188.11402 30.796738 -2375.8946 - 490 0.049 1 -188.08713 32.642869 -2375.8945 - 500 0.05 1 -188.06032 34.504776 -2375.8945 - 510 0.051 1 -188.03383 36.362662 -2375.8945 - 520 0.052 1 -188.00793 38.197721 -2375.8945 - 530 0.053 1 -187.98284 39.992314 -2375.8945 - 540 0.054 1 -187.95884 41.730127 -2375.8945 - 550 0.055 1 -187.93612 43.396298 -2375.8945 - 560 0.056 1 -187.91489 44.97754 -2375.8945 - 570 0.057 1 -187.89524 46.462224 -2375.8945 - 580 0.058 1 -187.87735 47.840443 -2375.8945 - 590 0.059 1 -187.8613 49.104064 -2375.8945 - 600 0.06 1 -187.84719 50.246744 -2375.8945 - 610 0.061 1 -187.83509 51.26393 -2375.8944 - 620 0.062 1 -187.82506 52.152839 -2375.8944 - 630 0.063 1 -187.81706 52.912413 -2375.8944 - 640 0.064 1 -187.81109 53.543272 -2375.8944 - 650 0.065 1 -187.80708 54.047636 -2375.8944 - 660 0.066 1 -187.80499 54.429234 -2375.8944 - 670 0.067 1 -187.8047 54.693202 -2375.8944 - 680 0.068 1 -187.80613 54.845965 -2375.8944 - 690 0.069 1 -187.80914 54.895106 -2375.8944 - 700 0.07 1 -187.81356 54.849238 -2375.8944 - 710 0.071 1 -187.81923 54.71786 -2375.8943 - 720 0.072 1 -187.82608 54.511181 -2375.8943 - 730 0.073 1 -187.83388 54.239987 -2375.8943 - 740 0.074 1 -187.84244 53.91548 -2375.8943 - 750 0.075 1 -187.85158 53.549112 -2375.8943 - 760 0.076 1 -187.86112 53.152433 -2375.8943 - 770 0.077 1 -187.87086 52.736925 -2375.8943 - 780 0.078 1 -187.88063 52.313858 -2375.8943 - 790 0.079 1 -187.89026 51.894138 -2375.8943 - 800 0.08 1 -187.89958 51.488169 -2375.8943 - 810 0.081 1 -187.90842 51.105725 -2375.8943 - 820 0.082 1 -187.91663 50.755829 -2375.8943 - 830 0.083 1 -187.92411 50.446651 -2375.8943 - 840 0.084 1 -187.93071 50.185404 -2375.8943 - 850 0.085 1 -187.93637 49.978262 -2375.8943 - 860 0.086 1 -187.94099 49.830307 -2375.8943 - 870 0.087 1 -187.9445 49.745473 -2375.8943 - 880 0.088 1 -187.94685 49.726517 -2375.8943 - 890 0.089 1 -187.94802 49.774999 -2375.8943 - 900 0.09 1 -187.94799 49.891282 -2375.8943 - 910 0.091 1 -187.94678 50.074549 -2375.8943 - 920 0.092 1 -187.94441 50.322833 -2375.8943 - 930 0.093 1 -187.94093 50.633063 -2375.8943 - 940 0.094 1 -187.93639 51.001126 -2375.8943 - 950 0.095 1 -187.93089 51.421938 -2375.8943 - 960 0.096 1 -187.9245 51.889531 -2375.8943 - 970 0.097 1 -187.91733 52.397148 -2375.8943 - 980 0.098 1 -187.9095 52.937345 -2375.8943 - 990 0.099 1 -187.90113 53.502108 -2375.8943 - 1000 0.1 1 -187.89236 54.082966 -2375.8943 - 1010 0.101 1 -187.88332 54.671115 -2375.8943 - 1020 0.102 1 -187.87415 55.257545 -2375.8943 - 1030 0.103 1 -187.86501 55.833162 -2375.8943 - 1040 0.104 1 -187.85602 56.388915 -2375.8943 - 1050 0.105 1 -187.84734 56.915918 -2375.8943 - 1060 0.106 1 -187.83909 57.405575 -2375.8943 - 1070 0.107 1 -187.83143 57.849686 -2375.8943 - 1080 0.108 1 -187.82446 58.240564 -2375.8943 - 1090 0.109 1 -187.8183 58.571132 -2375.8943 - 1100 0.11 1 -187.81306 58.835016 -2375.8943 - 1110 0.111 1 -187.80883 59.026633 -2375.8943 - 1120 0.112 1 -187.8057 59.141258 -2375.8943 - 1130 0.113 1 -187.80372 59.17509 -2375.8943 - 1140 0.114 1 -187.80295 59.125305 -2375.8943 - 1150 0.115 1 -187.80341 58.990092 -2375.8943 - 1160 0.116 1 -187.80515 58.76868 -2375.8943 - 1170 0.117 1 -187.80814 58.461352 -2375.8943 - 1180 0.118 1 -187.81244 58.069457 -2375.8943 - 1190 0.119 1 -187.81794 57.595377 -2375.8944 - 1200 0.12 1 -187.82458 57.042514 -2375.8944 - 1210 0.121 1 -187.83233 56.415256 -2375.8944 - 1220 0.122 1 -187.84112 55.718931 -2375.8944 - 1230 0.123 1 -187.85086 54.959744 -2375.8944 - 1240 0.124 1 -187.86145 54.144707 -2375.8944 - 1250 0.125 1 -187.87277 53.281562 -2375.8944 - 1260 0.126 1 -187.88471 52.378686 -2375.8944 - 1270 0.127 1 -187.89713 51.445 -2375.8944 - 1280 0.128 1 -187.9099 50.489858 -2375.8944 - 1290 0.129 1 -187.92288 49.522943 -2375.8944 - 1300 0.13 1 -187.93591 48.554147 -2375.8944 - 1310 0.131 1 -187.94886 47.593456 -2375.8944 - 1320 0.132 1 -187.96157 46.650829 -2375.8944 - 1330 0.133 1 -187.97391 45.736073 -2375.8944 - 1340 0.134 1 -187.98573 44.858733 -2375.8944 - 1350 0.135 1 -187.99691 44.027964 -2375.8944 - 1360 0.136 1 -188.00731 43.252426 -2375.8944 - 1370 0.137 1 -188.01678 42.540178 -2375.8943 - 1380 0.138 1 -188.02529 41.898568 -2375.8943 - 1390 0.139 1 -188.0327 41.334152 -2375.8943 - 1400 0.14 1 -188.03894 40.852606 -2375.8943 - 1410 0.141 1 -188.04396 40.45866 -2375.8944 - 1420 0.142 1 -188.04768 40.156041 -2375.8944 - 1430 0.143 1 -188.05007 39.947416 -2375.8944 - 1440 0.144 1 -188.05107 39.834367 -2375.8944 - 1450 0.145 1 -188.0507 39.817378 -2375.8944 - 1460 0.146 1 -188.04898 39.895828 -2375.8944 - 1470 0.147 1 -188.04595 40.068005 -2375.8945 - 1480 0.148 1 -188.04164 40.331129 -2375.8945 - 1490 0.149 1 -188.03603 40.681394 -2375.8945 - 1500 0.15 1 -188.02929 41.114003 -2375.8945 - 1510 0.151 1 -188.02148 41.623259 -2375.8945 - 1520 0.152 1 -188.0127 42.20263 -2375.8945 - 1530 0.153 1 -188.00302 42.844846 -2375.8945 - 1540 0.154 1 -187.99255 43.541977 -2375.8945 - 1550 0.155 1 -187.98148 44.285554 -2375.8945 - 1560 0.156 1 -187.96989 45.066666 -2375.8945 - 1570 0.157 1 -187.95793 45.876084 -2375.8945 - 1580 0.158 1 -187.94574 46.704378 -2375.8945 - 1590 0.159 1 -187.93346 47.542032 -2375.8945 - 1600 0.16 1 -187.92122 48.379564 -2375.8945 - 1610 0.161 1 -187.90916 49.207642 -2375.8945 - 1620 0.162 1 -187.89742 50.0172 -2375.8945 - 1630 0.163 1 -187.88613 50.799541 -2375.8945 - 1640 0.164 1 -187.87536 51.546446 -2375.8944 - 1650 0.165 1 -187.86531 52.250265 -2375.8944 - 1660 0.166 1 -187.85604 52.904001 -2375.8944 - 1670 0.167 1 -187.84765 53.501394 -2375.8944 - 1680 0.168 1 -187.84021 54.036987 -2375.8944 - 1690 0.169 1 -187.83379 54.506178 -2375.8944 - 1700 0.17 1 -187.82846 54.905273 -2375.8944 - 1710 0.171 1 -187.82424 55.231514 -2375.8944 - 1720 0.172 1 -187.82117 55.483104 -2375.8944 - 1730 0.173 1 -187.81922 55.659221 -2375.8944 - 1740 0.174 1 -187.81843 55.760007 -2375.8944 - 1750 0.175 1 -187.81881 55.786556 -2375.8944 - 1760 0.176 1 -187.82029 55.740888 -2375.8944 - 1770 0.177 1 -187.82284 55.625916 -2375.8944 - 1780 0.178 1 -187.82639 55.445397 -2375.8944 - 1790 0.179 1 -187.83088 55.203871 -2375.8944 - 1800 0.18 1 -187.83623 54.906597 -2375.8944 - 1810 0.181 1 -187.84235 54.559471 -2375.8944 - 1820 0.182 1 -187.84913 54.168949 -2375.8944 - 1830 0.183 1 -187.85646 53.741952 -2375.8943 - 1840 0.184 1 -187.86424 53.28578 -2375.8943 - 1850 0.185 1 -187.87239 52.807988 -2375.8943 - 1860 0.186 1 -187.88077 52.3163 -2375.8943 - 1870 0.187 1 -187.88925 51.81851 -2375.8943 - 1880 0.188 1 -187.89772 51.322368 -2375.8943 - 1890 0.189 1 -187.90605 50.835483 -2375.8943 - 1900 0.19 1 -187.91415 50.365218 -2375.8943 - 1910 0.191 1 -187.92189 49.9186 -2375.8943 - 1920 0.192 1 -187.92917 49.502222 -2375.8943 - 1930 0.193 1 -187.93591 49.122167 -2375.8943 - 1940 0.194 1 -187.94198 48.783928 -2375.8943 - 1950 0.195 1 -187.94737 48.492348 -2375.8943 - 1960 0.196 1 -187.95199 48.25154 -2375.8943 - 1970 0.197 1 -187.95576 48.064862 -2375.8943 - 1980 0.198 1 -187.95866 47.934875 -2375.8943 - 1990 0.199 1 -187.96065 47.863314 -2375.8943 - 2000 0.2 1 -187.96171 47.851079 -2375.8943 -Loop time of 4.40076 on 4 procs for 2000 steps with 500 atoms - -Performance: 3.927 ns/day, 6.112 hours/ns, 454.467 timesteps/s -96.2% 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.2934 | 1.3683 | 1.432 | 4.2 | 31.09 -Neigh | 0.005039 | 0.0053418 | 0.0054908 | 0.2 | 0.12 -Comm | 0.12642 | 0.1922 | 0.26891 | 11.6 | 4.37 -Output | 0.39256 | 0.40875 | 0.43431 | 2.5 | 9.29 -Modify | 2.395 | 2.4202 | 2.4352 | 1.0 | 54.99 -Other | | 0.006007 | | | 0.14 - -Nlocal: 125 ave 130 max 122 min -Histogram: 1 1 0 1 0 0 0 0 0 1 -Nghost: 1324 ave 1330 max 1316 min -Histogram: 1 0 0 1 0 0 0 0 0 2 -Neighs: 6747 ave 6959 max 6652 min -Histogram: 2 1 0 0 0 0 0 0 0 1 -FullNghs: 13494 ave 14060 max 13186 min -Histogram: 2 0 0 1 0 0 0 0 0 1 - -Total # of neighbors = 53976 -Ave neighs/atom = 107.952 -Neighbor list builds = 12 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:04 diff --git a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 new file mode 100644 index 0000000000..c534241f34 --- /dev/null +++ b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.1 @@ -0,0 +1,219 @@ +LAMMPS (30 Oct 2019) +# hcp cobalt in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice hcp 2.5071 +Lattice spacing in x,y,z = 2.5071 4.34242 4.09408 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.000491858 secs + +# setting mass, mag. moments, and interactions for hcp cobalt + +mass 1 58.93 + +set group all spin/random 31 1.72 + 500 settings made for spin/random +#set group all spin 1.72 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +#pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 -0.3593 1.135028015e-05 1.064568567 +#pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 +fix 1 all precession/spin anisotropy 0.01 0.0 0.0 1.0 +#fix 2 all langevin/spin 0.0 0.0 21 +fix 2 all langevin/spin 0.0 0.1 21 +fix 3 all nve/spin lattice moving + +timestep 0.0001 + + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_emag temp press etotal +thermo 10 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.59954 + ghost atom cutoff = 6.59954 + binsize = 3.29977, bins = 4 7 7 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.902 | 7.902 | 7.902 Mbytes +Step Time v_magnorm v_emag Temp Press TotEng + 0 0 0.076558814 -5.1073764 100.00543 -552.75983 -2190.3478 + 10 0.001 0.074494403 -6.2746901 100.01038 -1571.7966 -2191.5266 + 20 0.002 0.072366265 -7.4280779 99.885587 -2535.9845 -2192.6673 + 30 0.003 0.070127018 -8.5667999 99.611653 -3445.9872 -2193.7707 + 40 0.004 0.067755946 -9.6899272 99.164813 -4302.5715 -2194.8376 + 50 0.005 0.065261592 -10.79648 98.520535 -5107.2841 -2195.8697 + 60 0.006 0.062676613 -11.885341 97.657148 -5862.7198 -2196.8696 + 70 0.007 0.060046709 -12.955115 96.558718 -6572.0571 -2197.8404 + 80 0.008 0.057417313 -14.004096 95.216748 -7238.1396 -2198.7846 + 90 0.009 0.054822275 -15.030416 93.630634 -7862.5226 -2199.7028 + 100 0.01 0.052277835 -16.032345 91.80711 -8445.2646 -2200.5936 + 110 0.011 0.049783153 -17.008652 89.759163 -8985.5937 -2201.4546 + 120 0.012 0.047326373 -17.958895 87.504922 -9483.1141 -2202.2836 + 130 0.013 0.044893289 -18.883574 85.066818 -9938.8838 -2203.08 + 140 0.014 0.042474822 -19.784052 82.471014 -10355.911 -2203.8457 + 150 0.015 0.040070404 -20.662271 79.746901 -10739.081 -2204.5843 + 160 0.016 0.037686856 -21.520294 76.926428 -11094.793 -2205.3015 + 170 0.017 0.035334961 -22.359822 74.043181 -11430.247 -2206.0035 + 180 0.018 0.033026799 -23.181822 71.131269 -11752.268 -2206.6955 + 190 0.019 0.030775544 -23.986406 68.224204 -12065.774 -2207.3807 + 200 0.02 0.028597121 -24.773013 65.353995 -12372.712 -2208.0582 + 210 0.021 0.026511775 -25.540835 62.55053 -12672.055 -2208.7235 + 220 0.022 0.02454383 -26.289327 59.841288 -12961.112 -2209.3704 + 230 0.023 0.02271918 -27.018625 57.251361 -13237.544 -2209.9931 + 240 0.024 0.021061271 -27.729714 54.80373 -13501.028 -2210.5885 + 250 0.025 0.019587072 -28.42449 52.519717 -13754.325 -2211.1572 + 260 0.026 0.018304494 -29.105398 50.419388 -14002.718 -2211.7031 + 270 0.027 0.017211977 -29.775134 48.521812 -14253.089 -2212.2321 + 280 0.028 0.016300002 -30.436204 46.845075 -14512.437 -2212.7508 + 290 0.029 0.015553519 -31.090499 45.405985 -14786.53 -2213.2644 + 300 0.03 0.014954102 -31.739026 44.219544 -15079.165 -2213.7764 + 310 0.031 0.014481189 -32.381585 43.298175 -15391.531 -2214.2875 + 320 0.032 0.014112494 -33.016984 42.650874 -15722.828 -2214.7966 + 330 0.033 0.013824206 -33.643289 42.282535 -16070.874 -2215.3011 + 340 0.034 0.013591568 -34.258323 42.19365 -16433.065 -2215.7983 + 350 0.035 0.013390035 -34.860184 42.380506 -16807.186 -2216.286 + 360 0.036 0.01319679 -35.447655 42.835832 -17191.816 -2216.763 + 370 0.037 0.012992271 -36.020512 43.549656 -17586.676 -2217.2292 + 380 0.038 0.012761486 -36.579332 44.510078 -17991.857 -2217.6857 + 390 0.039 0.012494918 -37.125414 45.703757 -18407.738 -2218.1336 + 400 0.04 0.0121888 -37.660321 47.115967 -18834.276 -2218.5743 + 410 0.041 0.011844474 -38.185489 48.730291 -19270.674 -2219.0083 + 420 0.042 0.011466715 -38.70192 50.528119 -19715.276 -2219.4355 + 430 0.043 0.011061388 -39.21005 52.488204 -20165.66 -2219.8551 + 440 0.044 0.010633241 -39.709778 54.586528 -20618.997 -2220.266 + 450 0.045 0.010184696 -40.200724 56.79654 -21072.538 -2220.6671 + 460 0.046 0.0097161044 -40.682449 59.089699 -21523.873 -2221.0575 + 470 0.047 0.0092271788 -41.154614 61.436133 -21970.922 -2221.4371 + 480 0.048 0.0087187266 -41.617256 63.805414 -22412.32 -2221.8064 + 490 0.049 0.0081937768 -42.070708 66.167399 -22847.061 -2222.1664 + 500 0.05 0.0076576327 -42.51563 68.493235 -23274.619 -2222.5187 + 510 0.051 0.0071170477 -42.952841 70.756444 -23694.559 -2222.8652 + 520 0.052 0.006579078 -43.383338 72.933996 -24106.717 -2223.2075 + 530 0.053 0.006050144 -43.807962 75.007131 -24510.338 -2223.5467 + 540 0.054 0.0055354475 -44.227552 76.961803 -24904.495 -2223.8833 + 550 0.055 0.0050386503 -44.64268 78.788647 -25287.341 -2224.2166 + 560 0.056 0.0045617699 -45.053996 80.4825 -25657.11 -2224.5456 + 570 0.057 0.0041054334 -45.461923 82.041527 -26011.443 -2224.8688 + 580 0.058 0.003669689 -45.866895 83.466142 -26348.265 -2225.1846 + 590 0.059 0.0032553824 -46.269219 84.757926 -26665.834 -2225.492 + 600 0.06 0.0028655752 -46.669125 85.918711 -26963.24 -2225.7906 + 610 0.061 0.0025060765 -47.066641 86.95 -27240.331 -2226.0806 + 620 0.062 0.0021839971 -47.461566 87.852838 -27497.728 -2226.3626 + 630 0.063 0.0019039581 -47.853462 88.628142 -27736.503 -2226.6376 + 640 0.064 0.0016633855 -48.241747 89.277364 -27957.91 -2226.9064 + 650 0.065 0.0014502904 -48.625803 89.803307 -28163.11 -2227.1692 + 660 0.066 0.0012463786 -49.005026 90.210807 -28352.881 -2227.4258 + 670 0.067 0.0010345087 -49.378935 90.507107 -28527.721 -2227.6754 + 680 0.068 0.00080788134 -49.747325 90.701795 -28688.395 -2227.9175 + 690 0.069 0.000586442 -50.110227 90.80636 -28836.094 -2228.1522 + 700 0.07 0.00046855102 -50.467799 90.833539 -28972.361 -2228.3797 + 710 0.071 0.00061091693 -50.82044 90.796649 -29099.44 -2228.6011 + 720 0.072 0.00094960177 -51.168606 90.709122 -29219.676 -2228.8175 + 730 0.073 0.0013742455 -51.512913 90.584346 -29335.643 -2229.0301 + 740 0.074 0.0018397629 -51.853957 90.435783 -29449.521 -2229.2396 + 750 0.075 0.0023216474 -52.192407 90.277231 -29563.316 -2229.4468 + 760 0.076 0.0028000512 -52.528883 90.123061 -29678.726 -2229.6522 + 770 0.077 0.0032569295 -52.863859 89.98824 -29797.079 -2229.8564 + 780 0.078 0.0036765431 -53.197843 89.888047 -29919.964 -2230.06 + 790 0.079 0.0040467094 -53.530921 89.837568 -30048.271 -2230.2638 + 800 0.08 0.0043597837 -53.862938 89.850978 -30182.622 -2230.4682 + 810 0.081 0.0046129296 -54.193489 89.940884 -30323.293 -2230.6737 + 820 0.082 0.0048076151 -54.522077 90.117797 -30470.468 -2230.8804 + 830 0.083 0.004948533 -54.84813 90.389814 -30624.056 -2231.0884 + 840 0.084 0.0050423324 -55.171024 90.762454 -30783.658 -2231.2974 + 850 0.085 0.0050965581 -55.490357 91.238681 -30949.141 -2231.5072 + 860 0.086 0.0051190641 -55.805904 91.818973 -31120.5 -2231.7177 + 870 0.087 0.0051180301 -56.117429 92.501449 -31297.412 -2231.9286 + 880 0.088 0.0051024116 -56.424751 93.281992 -31479.436 -2232.1393 + 890 0.089 0.005082454 -56.727832 94.154367 -31666.293 -2232.3495 + 900 0.09 0.0050697645 -57.026442 95.110386 -31857.043 -2232.5582 + 910 0.091 0.0050765431 -57.320291 96.140056 -32050.436 -2232.7645 + 920 0.092 0.0051139309 -57.609075 97.231838 -32245.079 -2232.9672 + 930 0.093 0.0051899535 -57.89236 98.372982 -32439.141 -2233.1648 + 940 0.094 0.0053078572 -58.169742 99.54995 -32630.727 -2233.3559 + 950 0.095 0.0054654923 -58.44083 100.74893 -32817.882 -2233.5392 + 960 0.096 0.0056558757 -58.705483 101.95638 -32999.116 -2233.7136 + 970 0.097 0.0058685513 -58.963698 103.15953 -33173.159 -2233.8785 + 980 0.098 0.0060912487 -59.215624 104.34681 -33338.961 -2234.0336 + 990 0.099 0.0063114886 -59.461806 105.50819 -33496.345 -2234.1794 + 1000 0.1 0.0065179843 -59.702883 106.63524 -33645.259 -2234.3168 +Loop time of 5.86376 on 1 procs for 1000 steps with 500 atoms + +Performance: 1.473 ns/day, 16.288 hours/ns, 170.539 timesteps/s +100.0% 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.9866 | 2.9866 | 2.9866 | 0.0 | 50.93 +Neigh | 0.016013 | 0.016013 | 0.016013 | 0.0 | 0.27 +Comm | 0.046018 | 0.046018 | 0.046018 | 0.0 | 0.78 +Output | 0.011075 | 0.011075 | 0.011075 | 0.0 | 0.19 +Modify | 2.7957 | 2.7957 | 2.7957 | 0.0 | 47.68 +Other | | 0.008332 | | | 0.14 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 2442 ave 2442 max 2442 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 27581 ave 27581 max 27581 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 55162 ave 55162 max 55162 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 55162 +Ave neighs/atom = 110.324 +Neighbor list builds = 7 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:05 diff --git a/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 new file mode 100644 index 0000000000..21adab3f19 --- /dev/null +++ b/examples/SPIN/cobalt_hcp/log.19Nov19.spin.cobalt_hcp.g++.4 @@ -0,0 +1,219 @@ +LAMMPS (30 Oct 2019) +# hcp cobalt in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice hcp 2.5071 +Lattice spacing in x,y,z = 2.5071 4.34242 4.09408 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.000671148 secs + +# setting mass, mag. moments, and interactions for hcp cobalt + +mass 1 58.93 + +set group all spin/random 31 1.72 + 500 settings made for spin/random +#set group all spin 1.72 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +#pair_style hybrid/overlay eam/alloy spin/exchange 4.0 spin/neel 4.0 +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 -0.3593 1.135028015e-05 1.064568567 +#pair_coeff * * spin/neel neel 4.0 0.0048 0.234 1.168 2.6905 0.705 0.652 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 1.0 0.0 0.0 1.0 +fix 1 all precession/spin anisotropy 0.01 0.0 0.0 1.0 +#fix 2 all langevin/spin 0.0 0.0 21 +fix 2 all langevin/spin 0.0 0.1 21 +fix 3 all nve/spin lattice moving + +timestep 0.0001 + + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_emag temp press etotal +thermo 10 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_cobalt_hcp.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.59954 + ghost atom cutoff = 6.59954 + binsize = 3.29977, bins = 4 7 7 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.814 | 7.814 | 7.815 Mbytes +Step Time v_magnorm v_emag Temp Press TotEng + 0 0 0.076558814 -5.1073764 100.00543 -552.75983 -2190.3478 + 10 0.001 0.074494512 -6.2728301 99.980769 -1570.0726 -2191.5261 + 20 0.002 0.072367013 -7.4259977 99.847801 -2531.5119 -2192.6655 + 30 0.003 0.070129365 -8.566306 99.586282 -3438.1309 -2193.7672 + 40 0.004 0.067761178 -9.6929189 99.171132 -4291.017 -2194.8323 + 50 0.005 0.065270916 -10.8048 98.575397 -5091.9111 -2195.8628 + 60 0.006 0.062690557 -11.900573 97.773618 -5843.4528 -2196.8612 + 70 0.007 0.060064592 -12.978381 96.745047 -6548.726 -2197.8306 + 80 0.008 0.05743694 -14.035923 95.476292 -7210.2954 -2198.773 + 90 0.009 0.054839883 -15.07074 93.963026 -7829.4252 -2199.689 + 100 0.01 0.052288504 -16.08066 92.210482 -8405.9983 -2200.5773 + 110 0.011 0.049782155 -17.064251 90.232741 -8939.3051 -2201.4357 + 120 0.012 0.047311759 -18.021135 88.051042 -9429.1353 -2202.2626 + 130 0.013 0.044869196 -18.952065 85.691573 -9876.5628 -2203.0575 + 140 0.014 0.042453961 -19.858739 83.18315 -10284.249 -2203.8215 + 150 0.015 0.040074171 -20.743348 80.555177 -10656.417 -2204.5569 + 160 0.016 0.037742459 -21.608 77.836156 -10998.818 -2205.2677 + 170 0.017 0.035470168 -22.454209 75.052994 -11318.525 -2205.9587 + 180 0.018 0.033263447 -23.282658 72.231211 -11623.118 -2206.6354 + 190 0.019 0.031122821 -24.093311 69.395936 -11919.248 -2207.3023 + 200 0.02 0.029045634 -24.88579 66.573223 -12211.306 -2207.9613 + 210 0.021 0.027029857 -25.659817 63.791041 -12500.812 -2208.6115 + 220 0.022 0.025077742 -26.415541 61.079413 -12787.018 -2209.2498 + 230 0.023 0.023198048 -27.153652 58.469604 -13068.277 -2209.8722 + 240 0.024 0.02140599 -27.875313 55.992687 -13343.621 -2210.4756 + 250 0.025 0.019720922 -28.581973 53.678031 -13613.86 -2211.0588 + 260 0.026 0.018162738 -29.275283 51.552191 -13882.15 -2211.6232 + 270 0.027 0.016748514 -29.956802 49.638467 -14153.137 -2212.1718 + 280 0.028 0.01549075 -30.628043 47.957071 -14432.246 -2212.7087 + 290 0.029 0.014397611 -31.290177 46.525552 -14724.005 -2213.2371 + 300 0.03 0.013474315 -31.943984 45.359085 -15031.315 -2213.759 + 310 0.031 0.012723957 -32.589853 44.47023 -15355.595 -2214.275 + 320 0.032 0.012146358 -33.227585 43.868153 -15696.845 -2214.7851 + 330 0.033 0.011734827 -33.856656 43.557623 -16054.887 -2215.289 + 340 0.034 0.011472508 -34.476313 43.538346 -16429.77 -2215.7871 + 350 0.035 0.011330772 -35.085716 43.805034 -16821.627 -2216.2802 + 360 0.036 0.011271169 -35.684147 44.348312 -17230.21 -2216.7687 + 370 0.037 0.01125027 -36.271215 45.156046 -17654.485 -2217.2524 + 380 0.038 0.011225354 -36.847053 46.214576 -18092.623 -2217.7301 + 390 0.039 0.011159026 -37.412284 47.509345 -18542.156 -2218.2003 + 400 0.04 0.011022073 -37.967916 49.024843 -19000.554 -2218.6614 + 410 0.041 0.01079477 -38.515123 50.744046 -19465.713 -2219.1128 + 420 0.042 0.010467095 -39.054921 52.647653 -19935.873 -2219.5544 + 430 0.043 0.010038219 -39.588034 54.713405 -20409.666 -2219.9869 + 440 0.044 0.0095155267 -40.114703 56.915658 -20885.556 -2220.4109 + 450 0.045 0.0089134996 -40.634722 59.225397 -21361.621 -2220.8268 + 460 0.046 0.0082528918 -41.147681 61.610799 -21835.762 -2221.2347 + 470 0.047 0.0075606723 -41.653088 64.038349 -22305.687 -2221.6343 + 480 0.048 0.0068707613 -42.150486 66.474377 -22768.948 -2222.0253 + 490 0.049 0.0062249854 -42.639704 68.886721 -23223.418 -2222.4076 + 500 0.05 0.0056723593 -43.120772 71.24617 -23667.077 -2222.7814 + 510 0.051 0.00526312 -43.59404 73.527392 -24098.459 -2223.147 + 520 0.052 0.0050342241 -44.059917 75.709206 -24516.163 -2223.5051 + 530 0.053 0.0049906301 -44.518898 77.774314 -24919.192 -2223.8564 + 540 0.054 0.0050976586 -44.971364 79.708763 -25306.611 -2224.2014 + 550 0.055 0.0052941974 -45.417577 81.501347 -25677.67 -2224.5405 + 560 0.056 0.0055157717 -45.857628 83.143173 -26031.673 -2224.8736 + 570 0.057 0.0057113414 -46.291426 84.627457 -26367.904 -2225.2003 + 580 0.058 0.0058493207 -46.718709 85.949497 -26685.6 -2225.52 + 590 0.059 0.0059162201 -47.139052 87.10679 -26984.124 -2225.8316 + 600 0.06 0.0059118584 -47.551892 88.099176 -27263.145 -2226.1347 + 610 0.061 0.005843747 -47.956571 88.928929 -27522.773 -2226.4287 + 620 0.062 0.0057222223 -48.352422 89.600763 -27763.549 -2226.7139 + 630 0.063 0.0055570967 -48.738876 90.12173 -27986.321 -2226.9905 + 640 0.064 0.0053558993 -49.115723 90.501081 -28192.238 -2227.2593 + 650 0.065 0.0051233209 -49.483122 90.750056 -28382.3 -2227.5205 + 660 0.066 0.0048614512 -49.841791 90.881635 -28557.623 -2227.7746 + 670 0.067 0.0045706003 -50.192974 90.910245 -28719.422 -2228.0219 + 680 0.068 0.0042506564 -50.538196 90.851397 -28868.809 -2228.2627 + 690 0.069 0.0039028575 -50.879364 90.721317 -29007.619 -2228.4973 + 700 0.07 0.0035319814 -51.218193 90.536521 -29137.623 -2228.7265 + 710 0.071 0.0031491486 -51.556251 90.313501 -29261.193 -2228.9511 + 720 0.072 0.0027758205 -51.894643 90.068503 -29380.924 -2229.1724 + 730 0.073 0.002449449 -52.233987 89.817462 -29499.606 -2229.3917 + 740 0.074 0.0022276613 -52.574465 89.57612 -29620.196 -2229.6103 + 750 0.075 0.0021767124 -52.915641 89.360246 -29744.882 -2229.829 + 760 0.076 0.0023310362 -53.256843 89.185838 -29875.573 -2230.0485 + 770 0.077 0.0026637349 -53.597197 89.069228 -30013.477 -2230.2685 + 780 0.078 0.0031129938 -53.93565 89.026943 -30158.812 -2230.4882 + 790 0.079 0.0036204667 -54.271339 89.075322 -30311.602 -2230.7066 + 800 0.08 0.0041448552 -54.603455 89.229912 -30471.244 -2230.9226 + 810 0.081 0.0046613106 -54.931421 89.504766 -30636.938 -2231.1352 + 820 0.082 0.0051580947 -55.255056 89.911726 -30808.087 -2231.3434 + 830 0.083 0.0056329652 -55.574491 90.459766 -30984.153 -2231.5469 + 840 0.084 0.0060893356 -55.890024 91.154456 -31164.372 -2231.7452 + 850 0.085 0.0065324419 -56.202052 91.997528 -31347.792 -2231.9379 + 860 0.086 0.0069661977 -56.511206 92.986622 -31533.977 -2232.1249 + 870 0.087 0.0073913051 -56.817814 94.115192 -31721.92 -2232.306 + 880 0.088 0.0078048547 -57.122061 95.372548 -31910.795 -2232.4809 + 890 0.089 0.008201165 -57.423984 96.744135 -32100.108 -2232.65 + 900 0.09 0.0085732702 -57.723377 98.212046 -32289.532 -2232.8136 + 910 0.091 0.0089144724 -58.019938 99.755667 -32479.154 -2232.9728 + 920 0.092 0.0092194916 -58.313266 101.35254 -32669.227 -2233.1285 + 930 0.093 0.0094849872 -58.602956 102.97932 -32860.091 -2233.2822 + 940 0.094 0.0097093572 -58.888668 104.61271 -33051.981 -2233.4348 + 950 0.095 0.0098920175 -59.169925 106.23045 -33244.279 -2233.5871 + 960 0.096 0.01003244 -59.44662 107.81212 -33436.562 -2233.7396 + 970 0.097 0.010129313 -59.718668 109.33976 -33627.714 -2233.8925 + 980 0.098 0.010180127 -59.986126 110.79823 -33816.218 -2234.0455 + 990 0.099 0.010181304 -60.24929 112.17528 -34000.522 -2234.1984 + 1000 0.1 0.01012881 -60.508632 113.46137 -34179.052 -2234.3508 +Loop time of 4.82687 on 4 procs for 1000 steps with 500 atoms + +Performance: 1.790 ns/day, 13.408 hours/ns, 207.173 timesteps/s +97.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 | 1.1741 | 1.3056 | 1.4605 | 11.5 | 27.05 +Neigh | 0.0042465 | 0.0048378 | 0.0051758 | 0.5 | 0.10 +Comm | 0.31356 | 0.406 | 0.47906 | 11.6 | 8.41 +Output | 0.0090122 | 0.0094153 | 0.010493 | 0.6 | 0.20 +Modify | 3.0298 | 3.0936 | 3.1534 | 3.4 | 64.09 +Other | | 0.007349 | | | 0.15 + +Nlocal: 125 ave 136 max 119 min +Histogram: 1 1 1 0 0 0 0 0 0 1 +Nghost: 1324 ave 1331 max 1310 min +Histogram: 1 0 0 0 0 0 0 0 2 1 +Neighs: 6897.25 ave 7552 max 6604 min +Histogram: 2 1 0 0 0 0 0 0 0 1 +FullNghs: 13794.5 ave 15117 max 13164 min +Histogram: 2 0 1 0 0 0 0 0 0 1 + +Total # of neighbors = 55178 +Ave neighs/atom = 110.356 +Neighbor list builds = 7 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:04 diff --git a/examples/SPIN/dipole_spin/in.spin.iron_dipole_cut b/examples/SPIN/dipole_spin/in.spin.iron_dipole_cut index 34f7fea0d3..9c256338a2 100644 --- a/examples/SPIN/dipole_spin/in.spin.iron_dipole_cut +++ b/examples/SPIN/dipole_spin/in.spin.iron_dipole_cut @@ -11,7 +11,7 @@ boundary p p p atom_modify map array lattice bcc 2.8665 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 create_box 1 box create_atoms 1 box @@ -56,4 +56,4 @@ thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 100 diff --git a/examples/SPIN/dipole_spin/in.spin.iron_dipole_ewald b/examples/SPIN/dipole_spin/in.spin.iron_dipole_ewald index f694bc5ddc..560fcbb650 100644 --- a/examples/SPIN/dipole_spin/in.spin.iron_dipole_ewald +++ b/examples/SPIN/dipole_spin/in.spin.iron_dipole_ewald @@ -11,7 +11,7 @@ boundary p p p atom_modify map array lattice bcc 2.8665 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 create_box 1 box create_atoms 1 box @@ -58,4 +58,4 @@ thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 100 diff --git a/examples/SPIN/dipole_spin/in.spin.iron_dipole_pppm b/examples/SPIN/dipole_spin/in.spin.iron_dipole_pppm index 4175038ade..28d79e3d3e 100644 --- a/examples/SPIN/dipole_spin/in.spin.iron_dipole_pppm +++ b/examples/SPIN/dipole_spin/in.spin.iron_dipole_pppm @@ -11,7 +11,7 @@ boundary p p p atom_modify map array lattice bcc 2.8665 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 create_box 1 box create_atoms 1 box @@ -59,4 +59,4 @@ thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 100 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 new file mode 100644 index 0000000000..9c4b9e6877 --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.1 @@ -0,0 +1,125 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.00068903 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/cut 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/cut 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/cut, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 13.4 | 13.4 | 13.4 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 1.0737264e-35 -768.37511 -15560.055 -15515.394 + 50 0.005 -1 -2.7722752e-10 -2.1828666e-10 1 6.8846921e-09 -768.35793 -15558.423 -15515.394 + 100 0.01 -1 -2.0983066e-09 -1.7330951e-09 1 1.0038885e-08 -768.30868 -15553.81 -15515.394 +Loop time of 9.81833 on 1 procs for 100 steps with 3456 atoms + +Performance: 0.088 ns/day, 272.731 hours/ns, 10.185 timesteps/s +100.0% CPU use with 1 MPI tasks x no OpenMP threads + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 4.5684 | 4.5684 | 4.5684 | 0.0 | 46.53 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.022333 | 0.022333 | 0.022333 | 0.0 | 0.23 +Output | 0.0062339 | 0.0062339 | 0.0062339 | 0.0 | 0.06 +Modify | 5.2097 | 5.2097 | 5.2097 | 0.0 | 53.06 +Other | | 0.01171 | | | 0.12 + +Nlocal: 3456 ave 3456 max 3456 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7289 ave 7289 max 7289 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 290304 ave 290304 max 290304 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 580608 ave 580608 max 580608 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:09 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 new file mode 100644 index 0000000000..6bd13bff4b --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_cut.g++.4 @@ -0,0 +1,125 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.00121498 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/cut 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/cut 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/cut, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 9.217 | 9.217 | 9.217 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 1.0737264e-35 -768.37511 -15560.055 -15515.394 + 50 0.005 -1 9.6204015e-11 -3.3767807e-10 1 6.6905249e-09 -768.35767 -15558.438 -15515.394 + 100 0.01 -1 7.8881609e-10 -2.7017321e-09 1 9.8111281e-09 -768.30769 -15553.868 -15515.394 +Loop time of 4.21054 on 4 procs for 100 steps with 3456 atoms + +Performance: 0.205 ns/day, 116.959 hours/ns, 23.750 timesteps/s +97.9% 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.5515 | 1.5909 | 1.6287 | 2.8 | 37.78 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.1219 | 0.15371 | 0.18852 | 8.1 | 3.65 +Output | 0.0032659 | 0.0032846 | 0.0033138 | 0.0 | 0.08 +Modify | 2.4491 | 2.4549 | 2.4589 | 0.3 | 58.30 +Other | | 0.007701 | | | 0.18 + +Nlocal: 864 ave 864 max 864 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 3785 ave 3785 max 3785 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 72576 ave 72576 max 72576 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 145152 ave 145152 max 145152 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:04 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 new file mode 100644 index 0000000000..9bd3b04a06 --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.1 @@ -0,0 +1,135 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.000730038 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/long 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/long 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +kspace_style ewald/dipole/spin 1.0e-4 + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +EwaldDipoleSpin initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:323) + G vector (1/distance) = 0.324623 + estimated absolute RMS force accuracy = 9.55526e-84 + estimated relative force accuracy = 6.63576e-85 + KSpace vectors: actual max1d max3d = 2084 10 4630 + kxmax kymax kzmax = 10 10 10 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/long, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 30.07 | 30.07 | 30.07 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 2.5872886e-37 -767.88567 -15559.577 -15514.916 + 50 0.005 -1 4.3660916e-09 -2.1918692e-09 1 5.3480999e-10 -767.86847 -15557.945 -15514.916 + 100 0.01 -1 9.9854966e-09 -4.2823677e-09 1 2.3267629e-09 -767.81917 -15553.332 -15514.916 +Loop time of 30.1001 on 1 procs for 100 steps with 3456 atoms + +Performance: 0.029 ns/day, 836.115 hours/ns, 3.322 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 | 5.6659 | 5.6659 | 5.6659 | 0.0 | 18.82 +Kspace | 12.686 | 12.686 | 12.686 | 0.0 | 42.14 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.022781 | 0.022781 | 0.022781 | 0.0 | 0.08 +Output | 0.00965 | 0.00965 | 0.00965 | 0.0 | 0.03 +Modify | 11.705 | 11.705 | 11.705 | 0.0 | 38.89 +Other | | 0.01108 | | | 0.04 + +Nlocal: 3456 ave 3456 max 3456 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7289 ave 7289 max 7289 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 290304 ave 290304 max 290304 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 580608 ave 580608 max 580608 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:30 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 new file mode 100644 index 0000000000..4989210d1d --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_ewald.g++.4 @@ -0,0 +1,135 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.00238299 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/long 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/long 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +kspace_style ewald/dipole/spin 1.0e-4 + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +EwaldDipoleSpin initialization ... + using 12-bit tables for long-range coulomb (../kspace.cpp:323) + G vector (1/distance) = 0.324623 + estimated absolute RMS force accuracy = 9.29828e-84 + estimated relative force accuracy = 6.4573e-85 + KSpace vectors: actual max1d max3d = 2084 10 4630 + kxmax kymax kzmax = 10 10 10 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/long, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 25.89 | 25.89 | 25.89 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 3.5107565e-37 -767.88567 -15559.577 -15514.916 + 50 0.005 -1 4.3196063e-09 -2.1966927e-09 1 5.1719577e-10 -767.86822 -15557.96 -15514.916 + 100 0.01 -1 9.7636593e-09 -4.3236953e-09 1 2.2443181e-09 -767.81819 -15553.39 -15514.916 +Loop time of 11.709 on 4 procs for 100 steps with 3456 atoms + +Performance: 0.074 ns/day, 325.251 hours/ns, 8.540 timesteps/s +99.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 | 1.7524 | 1.9105 | 2.0593 | 9.8 | 16.32 +Kspace | 4.1375 | 4.4309 | 4.7029 | 12.3 | 37.84 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.063121 | 0.47268 | 0.94431 | 59.7 | 4.04 +Output | 0.0032601 | 0.0033116 | 0.0033839 | 0.1 | 0.03 +Modify | 4.8621 | 4.8828 | 4.9008 | 0.8 | 41.70 +Other | | 0.008918 | | | 0.08 + +Nlocal: 864 ave 864 max 864 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 3785 ave 3785 max 3785 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 72576 ave 72576 max 72576 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 145152 ave 145152 max 145152 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:11 diff --git a/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 new file mode 100644 index 0000000000..5984976c8d --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.1 @@ -0,0 +1,137 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.000930071 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/long 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/long 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +kspace_style pppm/dipole/spin 1.0e-4 +kspace_modify compute yes + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +PPPMDipoleSpin initialization ... + G vector (1/distance) = 0.329367 + grid = 20 20 20 + stencil order = 5 + estimated absolute RMS force accuracy = 0.00175808 + estimated relative force accuracy = 0.000122092 + using double precision FFTs + 3d grid and FFT values/proc = 15625 8000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/long, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 16.27 | 16.27 | 16.27 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 3.7996771e-37 -767.89759 -15559.59 -15514.929 + 50 0.005 -1 3.6585337e-09 -1.9445403e-09 1 5.1405121e-10 -767.88039 -15557.958 -15514.929 + 100 0.01 -1 7.3585728e-09 -3.8640878e-09 1 2.0194927e-09 -767.83109 -15553.345 -15514.929 +Loop time of 18.493 on 1 procs for 100 steps with 3456 atoms + +Performance: 0.047 ns/day, 513.694 hours/ns, 5.407 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 | 5.7715 | 5.7715 | 5.7715 | 0.0 | 31.21 +Kspace | 0.82553 | 0.82553 | 0.82553 | 0.0 | 4.46 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.022319 | 0.022319 | 0.022319 | 0.0 | 0.12 +Output | 0.0066397 | 0.0066397 | 0.0066397 | 0.0 | 0.04 +Modify | 11.857 | 11.857 | 11.857 | 0.0 | 64.12 +Other | | 0.009629 | | | 0.05 + +Nlocal: 3456 ave 3456 max 3456 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 7289 ave 7289 max 7289 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 290304 ave 290304 max 290304 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 580608 ave 580608 max 580608 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +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/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 new file mode 100644 index 0000000000..154e39958d --- /dev/null +++ b/examples/SPIN/dipole_spin/log.19Nov19.spin.iron_dipole_pppm.g++.4 @@ -0,0 +1,137 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 12.0 0.0 12.0 0.0 12.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (34.398 34.398 34.398) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 3456 atoms + create_atoms CPU = 0.00089097 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin 2.2 -1.0 0.0 0.0 + 3456 settings made for spin +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 spin/dipole/long 8.0 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 +pair_coeff * * spin/dipole/long 8.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +kspace_style pppm/dipole/spin 1.0e-4 +kspace_modify compute yes + +fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 100 +PPPMDipoleSpin initialization ... + G vector (1/distance) = 0.329367 + grid = 20 20 20 + stencil order = 5 + estimated absolute RMS force accuracy = 0.00175808 + estimated relative force accuracy = 0.000122092 + using double precision FFTs + 3d grid and FFT values/proc = 5625 2000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 8.1 + ghost atom cutoff = 8.1 + binsize = 4.05, bins = 9 9 9 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (3) pair spin/dipole/long, perpetual, copy from (2) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 10.42 | 10.42 | 10.42 Mbytes +Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng + 0 0 -1 0 0 1 2.3173191e-37 -767.89759 -15559.59 -15514.929 + 50 0.005 -1 3.6593054e-09 -1.9379563e-09 1 4.9747018e-10 -767.88014 -15557.972 -15514.929 + 100 0.01 -1 7.3731919e-09 -3.8151563e-09 1 1.9544299e-09 -767.8301 -15553.402 -15514.929 +Loop time of 6.23322 on 4 procs for 100 steps with 3456 atoms + +Performance: 0.139 ns/day, 173.145 hours/ns, 16.043 timesteps/s +99.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 | 1.6633 | 1.6906 | 1.7152 | 1.4 | 27.12 +Kspace | 0.38875 | 0.41372 | 0.44184 | 3.0 | 6.64 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.05118 | 0.053267 | 0.054998 | 0.6 | 0.85 +Output | 0.0070119 | 0.0070257 | 0.0070462 | 0.0 | 0.11 +Modify | 4.0616 | 4.0629 | 4.0646 | 0.1 | 65.18 +Other | | 0.005713 | | | 0.09 + +Nlocal: 864 ave 864 max 864 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 3785 ave 3785 max 3785 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Neighs: 72576 ave 72576 max 72576 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 145152 ave 145152 max 145152 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 580608 +Ave neighs/atom = 168 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:06 diff --git a/examples/SPIN/iron/in.spin.iron b/examples/SPIN/iron/in.spin.iron index 93485ee076..d60e6b86f5 100644 --- a/examples/SPIN/iron/in.spin.iron +++ b/examples/SPIN/iron/in.spin.iron @@ -19,8 +19,8 @@ create_atoms 1 box mass 1 55.845 -#set group all spin/random 31 2.2 -set group all spin 2.2 0.0 0.0 1.0 +set group all spin/random 31 2.2 +# set group all spin 2.2 0.0 0.0 1.0 velocity all create 100 4928459 rot yes dist gaussian pair_style hybrid/overlay eam/alloy spin/exchange 3.5 @@ -54,4 +54,4 @@ thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 50000 +run 1000 diff --git a/examples/SPIN/iron/in.spin.iron_cubic b/examples/SPIN/iron/in.spin.iron_cubic index 349a6de3a0..30a3e0e97c 100644 --- a/examples/SPIN/iron/in.spin.iron_cubic +++ b/examples/SPIN/iron/in.spin.iron_cubic @@ -54,7 +54,7 @@ thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 1000 # min_style spin # min_modify alpha_damp 1.0 discrete_factor 10 # minimize 1.0e-16 1.0e-16 10000 10000 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 new file mode 100644 index 0000000000..cee42d433b --- /dev/null +++ b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.1 @@ -0,0 +1,136 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 250 atoms + create_atoms CPU = 0.000509977 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 + +set group all spin/random 31 2.2 + 250 settings made for spin/random +# set group all spin 2.2 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe press etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.77337 + ghost atom cutoff = 5.77337 + binsize = 2.88668, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.82 | 7.82 | 7.82 Mbytes +Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng Press TotEng + 0 0 0.076456975 4554.5462 100.00358 -0.85791269 3.2186929 -1070.8579 394.43342 -1067.6392 + 50 0.005 0.076456974 4658.383 96.663685 -0.86504718 3.1111957 -1070.7504 709.50826 -1067.6392 + 100 0.01 0.076456983 4744.1872 86.965803 -0.88035771 2.7990619 -1070.4383 1466.6938 -1067.6392 + 150 0.015 0.076456973 4794.5283 72.421197 -0.8996913 2.3309324 -1069.9702 2534.3867 -1067.6392 + 200 0.02 0.076456944 4707.6548 55.633188 -0.921682 1.7905973 -1069.4298 3732.183 -1067.6392 + 250 0.025 0.076456953 4439.4697 39.802206 -0.94649004 1.2810649 -1068.9203 4831.5559 -1067.6392 + 300 0.03 0.076457027 4101.6694 27.882295 -0.97253854 0.8974133 -1068.5366 5612.0928 -1067.6392 + 350 0.035 0.076457103 3860.1545 21.776538 -0.99708692 0.70089477 -1068.3401 5906.3057 -1067.6392 + 400 0.04 0.076457117 3765.5341 21.857102 -1.0190244 0.70348778 -1068.3427 5682.0053 -1067.6392 + 450 0.045 0.076457072 3739.9037 26.959407 -1.0389343 0.86770942 -1068.5069 5066.5077 -1067.6392 + 500 0.05 0.076457001 3730.8342 34.92521 -1.0582008 1.124095 -1068.7633 4279.2424 -1067.6392 + 550 0.055 0.076456962 3698.0556 43.405912 -1.0785156 1.397053 -1069.0363 3533.4153 -1067.6392 + 600 0.06 0.076456997 3560.947 50.544844 -1.102048 1.626825 -1069.2661 2975.8479 -1067.6392 + 650 0.065 0.076457079 3341.7402 55.261218 -1.1296588 1.7786252 -1069.4179 2683.3023 -1067.6392 + 700 0.07 0.076457136 3156.8448 57.25083 -1.1595102 1.8426624 -1069.4819 2640.5967 -1067.6392 + 750 0.075 0.076457132 3099.5181 56.934336 -1.1893875 1.8324758 -1069.4717 2778.3261 -1067.6392 + 800 0.08 0.076457116 3132.9985 55.266343 -1.2181223 1.7787901 -1069.418 3020.1175 -1067.6392 + 850 0.085 0.076457116 3163.2943 53.376453 -1.2443326 1.7179626 -1069.3572 3287.9042 -1067.6392 + 900 0.09 0.076457121 3168.063 52.279557 -1.2676425 1.6826581 -1069.3219 3504.7334 -1067.6392 + 950 0.095 0.076457122 3144.2102 52.667743 -1.2902335 1.6951522 -1069.3344 3622.1382 -1067.6392 + 1000 0.1 0.076457135 3061.0811 54.684094 -1.314147 1.76005 -1069.3993 3625.2935 -1067.6392 +Loop time of 2.06841 on 1 procs for 1000 steps with 250 atoms + +Performance: 4.177 ns/day, 5.746 hours/ns, 483.464 timesteps/s +99.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 | 0.96898 | 0.96898 | 0.96898 | 0.0 | 46.85 +Neigh | 0.005435 | 0.005435 | 0.005435 | 0.0 | 0.26 +Comm | 0.028027 | 0.028027 | 0.028027 | 0.0 | 1.36 +Output | 0.0051067 | 0.0051067 | 0.0051067 | 0.0 | 0.25 +Modify | 1.0569 | 1.0569 | 1.0569 | 0.0 | 51.10 +Other | | 0.003989 | | | 0.19 + +Nlocal: 250 ave 250 max 250 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1399 ave 1399 max 1399 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 7855 ave 7855 max 7855 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 15710 ave 15710 max 15710 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 15710 +Ave neighs/atom = 62.84 +Neighbor list builds = 6 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:02 diff --git a/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 new file mode 100644 index 0000000000..63ddc9d4fe --- /dev/null +++ b/examples/SPIN/iron/log.19Nov19.spin.iron.g++.4 @@ -0,0 +1,136 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 250 atoms + create_atoms CPU = 0.000626087 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 + +set group all spin/random 31 2.2 + 250 settings made for spin/random +# set group all spin 2.2 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 3.5 +pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe +pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe press etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.77337 + ghost atom cutoff = 5.77337 + binsize = 2.88668, bins = 5 5 5 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.766 | 7.766 | 7.766 Mbytes +Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng Press TotEng + 0 0 0.076456975 4554.5462 100.00358 -0.85791269 3.2186929 -1070.8579 394.43342 -1067.6392 + 50 0.005 0.076456995 4701.2004 96.298333 -0.85659448 3.0994366 -1070.7387 714.37866 -1067.6392 + 100 0.01 0.076457028 4794.5923 86.330828 -0.87003341 2.7786247 -1070.4179 1484.2951 -1067.6392 + 150 0.015 0.076457074 4836.9634 71.603402 -0.89006992 2.3046111 -1069.9438 2551.9258 -1067.6392 + 200 0.02 0.076457106 4754.5574 54.648817 -0.91124541 1.7589146 -1069.3981 3731.1494 -1067.6392 + 250 0.025 0.076457128 4502.135 38.599515 -0.93187522 1.2423553 -1068.8816 4804.619 -1067.6392 + 300 0.03 0.076457157 4176.7186 26.383018 -0.95082226 0.8491579 -1068.4884 5563.3287 -1067.6392 + 350 0.035 0.076457207 3955.5658 20.01039 -0.96826468 0.64404992 -1068.2833 5839.6479 -1067.6392 + 400 0.04 0.076457243 3887.9746 20.097682 -0.98706373 0.64685949 -1068.2861 5601.1255 -1067.6392 + 450 0.045 0.076457231 3868.5613 25.687511 -1.0095684 0.82677249 -1068.466 4974.0031 -1067.6392 + 500 0.05 0.076457204 3838.4905 34.604697 -1.0349855 1.113779 -1068.753 4157.1837 -1067.6392 + 550 0.055 0.076457196 3775.1404 44.251809 -1.0609123 1.4242788 -1069.0635 3357.1 -1067.6392 + 600 0.06 0.076457188 3604.8828 52.475202 -1.0880854 1.6889551 -1069.3282 2752.0424 -1067.6392 + 650 0.065 0.07645718 3345.5894 57.926479 -1.1179657 1.8644087 -1069.5036 2467.7403 -1067.6392 + 700 0.07 0.076457185 3138.2001 60.030548 -1.1469999 1.9321298 -1069.5714 2510.1752 -1067.6392 + 750 0.075 0.07645719 3074.9626 59.122504 -1.1721939 1.9029037 -1069.5421 2788.7489 -1067.6392 + 800 0.08 0.076457195 3103.5294 56.349146 -1.1949365 1.813641 -1069.4529 3192.5158 -1067.6392 + 850 0.085 0.076457199 3164.2317 53.154464 -1.2164642 1.7108177 -1069.35 3602.931 -1067.6392 + 900 0.09 0.076457199 3228.1358 50.837416 -1.2366018 1.6362417 -1069.2755 3917.0758 -1067.6392 + 950 0.095 0.076457222 3247.5532 50.234549 -1.2539657 1.6168379 -1069.2561 4059.9275 -1067.6392 + 1000 0.1 0.076457266 3208.3875 51.592727 -1.2671834 1.6605519 -1069.2998 4001.4995 -1067.6392 +Loop time of 2.27244 on 4 procs for 1000 steps with 250 atoms + +Performance: 3.802 ns/day, 6.312 hours/ns, 440.055 timesteps/s +97.9% 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.33296 | 0.37066 | 0.40364 | 4.3 | 16.31 +Neigh | 0.0013368 | 0.0025837 | 0.0056586 | 3.5 | 0.11 +Comm | 0.12627 | 0.16094 | 0.20183 | 7.1 | 7.08 +Output | 0.0033641 | 0.003438 | 0.0036473 | 0.2 | 0.15 +Modify | 1.7249 | 1.7261 | 1.7272 | 0.1 | 75.96 +Other | | 0.008682 | | | 0.38 + +Nlocal: 62.5 ave 66 max 60 min +Histogram: 1 0 0 2 0 0 0 0 0 1 +Nghost: 844 ave 857 max 829 min +Histogram: 1 0 0 1 0 0 0 0 1 1 +Neighs: 1962.5 ave 2096 max 1855 min +Histogram: 1 0 1 0 0 1 0 0 0 1 +FullNghs: 3925 ave 4139 max 3766 min +Histogram: 1 0 0 2 0 0 0 0 0 1 + +Total # of neighbors = 15700 +Ave neighs/atom = 62.8 +Neighbor list builds = 6 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:02 diff --git a/examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.1 b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 similarity index 59% rename from examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.1 rename to examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 index ee1e71131e..26fdfb0004 100644 --- a/examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.1 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.1 @@ -1,9 +1,7 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task +LAMMPS (30 Oct 2019) # bcc iron in a 3d periodic box clear - using 1 OpenMP thread(s) per MPI task units metal atom_style spin @@ -21,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.0527296 secs + create_atoms CPU = 0.000481129 secs # setting mass, mag. moments, and interactions for bcc iron @@ -40,7 +38,7 @@ fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1 fix_modify 1 energy yes fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # compute and output options @@ -61,9 +59,9 @@ thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 1000 Neighbor list info ... update every 10 steps, delay 20 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -81,7 +79,7 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.319 | 7.319 | 7.319 Mbytes +Per MPI rank memory allocation (min/avg/max) = 7.82 | 7.82 | 7.82 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 0 0 -1 0 0 1 0 -55.58269 -1125.5827 -1122.364 50 0.005 -1 0 0 1 0 -55.581417 -1125.4672 -1122.364 @@ -104,53 +102,33 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 900 0.09 -1 0 0 1 0 -55.55913 -1123.8714 -1122.364 950 0.095 -1 0 0 1 0 -55.560111 -1123.8726 -1122.364 1000 0.1 -1 0 0 1 0 -55.560705 -1123.9215 -1122.364 - 1050 0.105 -1 0 0 1 0 -55.560979 -1124.0049 -1122.364 - 1100 0.11 -1 0 0 1 0 -55.561005 -1124.0998 -1122.364 - 1150 0.115 -1 0 0 1 0 -55.560847 -1124.1802 -1122.364 - 1200 0.12 -1 0 0 1 0 -55.560562 -1124.2247 -1122.364 - 1250 0.125 -1 0 0 1 0 -55.560199 -1124.2224 -1122.364 - 1300 0.13 -1 0 0 1 0 -55.559804 -1124.1752 -1122.364 - 1350 0.135 -1 0 0 1 0 -55.559416 -1124.0977 -1122.364 - 1400 0.14 -1 0 0 1 0 -55.559073 -1124.0124 -1122.364 - 1450 0.145 -1 0 0 1 0 -55.558803 -1123.9437 -1122.364 - 1500 0.15 -1 0 0 1 0 -55.558617 -1123.9107 -1122.364 - 1550 0.155 -1 0 0 1 0 -55.558503 -1123.9224 -1122.364 - 1600 0.16 -1 0 0 1 0 -55.558425 -1123.9749 -1122.364 - 1650 0.165 -1 0 0 1 0 -55.558323 -1124.0529 -1122.364 - 1700 0.17 -1 0 0 1 0 -55.558122 -1124.1331 -1122.364 - 1750 0.175 -1 0 0 1 0 -55.557751 -1124.1899 -1122.364 - 1800 0.18 -1 0 0 1 0 -55.557157 -1124.2023 -1122.364 - 1850 0.185 -1 0 0 1 0 -55.556326 -1124.1592 -1122.364 - 1900 0.19 -1 0 0 1 0 -55.555301 -1124.0633 -1122.364 - 1950 0.195 -1 0 0 1 0 -55.554178 -1123.9313 -1122.364 - 2000 0.2 -1 0 0 1 0 -55.553099 -1123.7904 -1122.364 -Loop time of 254.052 on 1 procs for 2000 steps with 250 atoms +Loop time of 1.95614 on 1 procs for 1000 steps with 250 atoms -Performance: 0.068 ns/day, 352.850 hours/ns, 7.872 timesteps/s -99.5% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 4.417 ns/day, 5.434 hours/ns, 511.211 timesteps/s +100.0% CPU use with 1 MPI tasks x no OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 60.584 | 60.584 | 60.584 | 0.0 | 23.85 -Neigh | 0.34793 | 0.34793 | 0.34793 | 0.0 | 0.14 -Comm | 1.9994 | 1.9994 | 1.9994 | 0.0 | 0.79 -Output | 126.24 | 126.24 | 126.24 | 0.0 | 49.69 -Modify | 64.475 | 64.475 | 64.475 | 0.0 | 25.38 -Other | | 0.4024 | | | 0.16 +Pair | 0.90008 | 0.90008 | 0.90008 | 0.0 | 46.01 +Neigh | 0.005214 | 0.005214 | 0.005214 | 0.0 | 0.27 +Comm | 0.026026 | 0.026026 | 0.026026 | 0.0 | 1.33 +Output | 0.0045307 | 0.0045307 | 0.0045307 | 0.0 | 0.23 +Modify | 1.0168 | 1.0168 | 1.0168 | 0.0 | 51.98 +Other | | 0.003449 | | | 0.18 Nlocal: 250 ave 250 max 250 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1419 ave 1419 max 1419 min +Nghost: 1415 ave 1415 max 1415 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 7878 ave 7878 max 7878 min +Neighs: 7873 ave 7873 max 7873 min Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 15756 ave 15756 max 15756 min +FullNghs: 15746 ave 15746 max 15746 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Total # of neighbors = 15756 -Ave neighs/atom = 63.024 -Neighbor list builds = 12 +Total # of neighbors = 15746 +Ave neighs/atom = 62.984 +Neighbor list builds = 6 Dangerous builds = 0 # min_style spin # min_modify alpha_damp 1.0 discrete_factor 10 @@ -158,4 +136,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:04:16 +Total wall time: 0:00:01 diff --git a/examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.4 b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 similarity index 58% rename from examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.4 rename to examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 index 677805d26a..2c911cb9bb 100644 --- a/examples/SPIN/iron/log.30Apr19.spin.iron_cubic.g++.4 +++ b/examples/SPIN/iron/log.19Nov19.spin.iron_cubic.g++.4 @@ -1,9 +1,7 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task +LAMMPS (30 Oct 2019) # bcc iron in a 3d periodic box clear - using 1 OpenMP thread(s) per MPI task units metal atom_style spin @@ -21,7 +19,7 @@ Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 250 atoms - create_atoms CPU = 0.000627756 secs + create_atoms CPU = 0.000656843 secs # setting mass, mag. moments, and interactions for bcc iron @@ -40,7 +38,7 @@ fix 1 all precession/spin cubic 0.001 0.0005 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1 fix_modify 1 energy yes fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # compute and output options @@ -61,9 +59,9 @@ thermo_style custom step time v_magx v_magy v_magz v_magnorm v_tmag v_emag pe thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] +dump 1 all custom 100 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] -run 2000 +run 1000 Neighbor list info ... update every 10 steps, delay 20 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -81,7 +79,7 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.265 | 7.265 | 7.265 Mbytes +Per MPI rank memory allocation (min/avg/max) = 7.766 | 7.766 | 7.766 Mbytes Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 0 0 -1 0 0 1 0 -55.58269 -1125.5827 -1122.364 50 0.005 -1 0 0 1 0 -55.581457 -1125.4635 -1122.364 @@ -104,53 +102,33 @@ Step Time v_magx v_magy v_magz v_magnorm v_tmag v_emag PotEng TotEng 900 0.09 -1 0 0 1 0 -55.560147 -1123.8404 -1122.364 950 0.095 -1 0 0 1 0 -55.560992 -1123.8312 -1122.364 1000 0.1 -1 0 0 1 0 -55.561635 -1123.8853 -1122.364 - 1050 0.105 -1 0 0 1 0 -55.562156 -1123.9898 -1122.364 - 1100 0.11 -1 0 0 1 0 -55.562594 -1124.1174 -1122.364 - 1150 0.115 -1 0 0 1 0 -55.562944 -1124.2349 -1122.364 - 1200 0.12 -1 0 0 1 0 -55.563163 -1124.3115 -1122.364 - 1250 0.125 -1 0 0 1 0 -55.563193 -1124.3273 -1122.364 - 1300 0.13 -1 0 0 1 0 -55.562982 -1124.2776 -1122.364 - 1350 0.135 -1 0 0 1 0 -55.562513 -1124.1744 -1122.364 - 1400 0.14 -1 0 0 1 0 -55.561812 -1124.0433 -1122.364 - 1450 0.145 -1 0 0 1 0 -55.560956 -1123.9169 -1122.364 - 1500 0.15 -1 0 0 1 0 -55.560057 -1123.8268 -1122.364 - 1550 0.155 -1 0 0 1 0 -55.559235 -1123.7951 -1122.364 - 1600 0.16 -1 0 0 1 0 -55.55859 -1123.8282 -1122.364 - 1650 0.165 -1 0 0 1 0 -55.558174 -1123.9155 -1122.364 - 1700 0.17 -1 0 0 1 0 -55.557974 -1124.0311 -1122.364 - 1750 0.175 -1 0 0 1 0 -55.557913 -1124.1409 -1122.364 - 1800 0.18 -1 0 0 1 0 -55.55788 -1124.212 -1122.364 - 1850 0.185 -1 0 0 1 0 -55.557753 -1124.2208 -1122.364 - 1900 0.19 -1 0 0 1 0 -55.557448 -1124.1596 -1122.364 - 1950 0.195 -1 0 0 1 0 -55.556942 -1124.0384 -1122.364 - 2000 0.2 -1 0 0 1 0 -55.556288 -1123.883 -1122.364 -Loop time of 4.39485 on 4 procs for 2000 steps with 250 atoms +Loop time of 2.38457 on 4 procs for 1000 steps with 250 atoms -Performance: 3.932 ns/day, 6.104 hours/ns, 455.078 timesteps/s -98.3% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 3.623 ns/day, 6.624 hours/ns, 419.362 timesteps/s +97.2% 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.64527 | 0.6695 | 0.71114 | 3.3 | 15.23 -Neigh | 0.0032711 | 0.0034365 | 0.0036387 | 0.3 | 0.08 -Comm | 0.14872 | 0.19108 | 0.21485 | 6.1 | 4.35 -Output | 0.40622 | 0.43119 | 0.45149 | 2.5 | 9.81 -Modify | 3.0688 | 3.0921 | 3.1179 | 1.0 | 70.36 -Other | | 0.007548 | | | 0.17 +Pair | 0.32773 | 0.36909 | 0.41504 | 6.0 | 15.48 +Neigh | 0.0014782 | 0.0015869 | 0.001724 | 0.2 | 0.07 +Comm | 0.14716 | 0.19316 | 0.23754 | 8.4 | 8.10 +Output | 0.0030437 | 0.0032653 | 0.0035224 | 0.3 | 0.14 +Modify | 1.8109 | 1.8139 | 1.8175 | 0.2 | 76.07 +Other | | 0.003611 | | | 0.15 -Nlocal: 62.5 ave 67 max 57 min -Histogram: 1 0 0 0 0 1 0 1 0 1 -Nghost: 850.5 ave 856 max 847 min -Histogram: 1 0 1 1 0 0 0 0 0 1 -Neighs: 1968.75 ave 2101 max 1792 min -Histogram: 1 0 0 0 0 1 0 1 0 1 -FullNghs: 3937.5 ave 4217 max 3583 min -Histogram: 1 0 0 0 0 1 0 1 0 1 +Nlocal: 62.5 ave 66 max 60 min +Histogram: 1 1 0 0 0 1 0 0 0 1 +Nghost: 848.25 ave 861 max 834 min +Histogram: 1 0 0 0 1 0 1 0 0 1 +Neighs: 1962.75 ave 2087 max 1870 min +Histogram: 1 1 0 0 0 0 1 0 0 1 +FullNghs: 3925.5 ave 4138 max 3776 min +Histogram: 1 1 0 0 0 1 0 0 0 1 -Total # of neighbors = 15750 -Ave neighs/atom = 63 -Neighbor list builds = 12 +Total # of neighbors = 15702 +Ave neighs/atom = 62.808 +Neighbor list builds = 6 Dangerous builds = 0 # min_style spin # min_modify alpha_damp 1.0 discrete_factor 10 @@ -158,4 +136,4 @@ Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:04 +Total wall time: 0:00:02 diff --git a/examples/SPIN/iron/log.30Apr19.spin.iron.g++.1 b/examples/SPIN/iron/log.30Apr19.spin.iron.g++.1 deleted file mode 100644 index f02c43e28c..0000000000 --- a/examples/SPIN/iron/log.30Apr19.spin.iron.g++.1 +++ /dev/null @@ -1,1117 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# bcc iron in a 3d periodic box - -clear - using 1 OpenMP thread(s) per MPI task -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice bcc 2.8665 -Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 250 atoms - create_atoms CPU = 0.00074935 secs - -# setting mass, mag. moments, and interactions for bcc iron - -mass 1 55.845 - -set group all spin/random 31 2.2 - 250 settings made for spin/random -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 3.5 -pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe -pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 50000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 5.77337 - ghost atom cutoff = 5.77337 - binsize = 2.88668, bins = 5 5 5 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.319 | 7.319 | 7.319 Mbytes -Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng TotEng - 0 0 0.076456975 9109.0924 100.00358 -0.85791269 3.2186929 -1070.8579 -1067.6392 - 50 0.005 0.076456974 9316.7659 96.663685 -0.86504718 3.1111957 -1070.7504 -1067.6392 - 100 0.01 0.076456983 9488.3743 86.965803 -0.88035771 2.7990619 -1070.4383 -1067.6392 - 150 0.015 0.076456973 9589.0566 72.421197 -0.8996913 2.3309324 -1069.9702 -1067.6392 - 200 0.02 0.076456944 9415.3095 55.633188 -0.921682 1.7905973 -1069.4298 -1067.6392 - 250 0.025 0.076456953 8878.9394 39.802206 -0.94649004 1.2810649 -1068.9203 -1067.6392 - 300 0.03 0.076457027 8203.3388 27.882295 -0.97253854 0.8974133 -1068.5366 -1067.6392 - 350 0.035 0.076457103 7720.309 21.776538 -0.99708692 0.70089477 -1068.3401 -1067.6392 - 400 0.04 0.076457117 7531.0683 21.857102 -1.0190244 0.70348778 -1068.3427 -1067.6392 - 450 0.045 0.076457072 7479.8073 26.959407 -1.0389343 0.86770942 -1068.5069 -1067.6392 - 500 0.05 0.076457001 7461.6683 34.92521 -1.0582008 1.124095 -1068.7633 -1067.6392 - 550 0.055 0.076456962 7396.1112 43.405912 -1.0785156 1.397053 -1069.0363 -1067.6392 - 600 0.06 0.076456997 7121.894 50.544844 -1.102048 1.626825 -1069.2661 -1067.6392 - 650 0.065 0.076457079 6683.4805 55.261218 -1.1296588 1.7786252 -1069.4179 -1067.6392 - 700 0.07 0.076457136 6313.6896 57.25083 -1.1595102 1.8426624 -1069.4819 -1067.6392 - 750 0.075 0.076457132 6199.0363 56.934336 -1.1893875 1.8324758 -1069.4717 -1067.6392 - 800 0.08 0.076457116 6265.997 55.266343 -1.2181223 1.7787901 -1069.418 -1067.6392 - 850 0.085 0.076457116 6326.5886 53.376453 -1.2443326 1.7179626 -1069.3572 -1067.6392 - 900 0.09 0.076457121 6336.1261 52.279557 -1.2676425 1.6826581 -1069.3219 -1067.6392 - 950 0.095 0.076457122 6288.4204 52.667743 -1.2902335 1.6951522 -1069.3344 -1067.6392 - 1000 0.1 0.076457135 6122.1622 54.684094 -1.314147 1.76005 -1069.3993 -1067.6392 - 1050 0.105 0.076457155 5830.2219 57.880399 -1.3392396 1.8629256 -1069.5022 -1067.6392 - 1100 0.11 0.076457162 5477.4214 61.505616 -1.3662331 1.979606 -1069.6188 -1067.6392 - 1150 0.115 0.076457195 5194.1423 64.810972 -1.3984474 2.0859914 -1069.7252 -1067.6392 - 1200 0.12 0.076457219 5096.2484 67.147472 -1.438326 2.1611935 -1069.8004 -1067.6392 - 1250 0.125 0.076457214 5180.7444 67.957533 -1.4822383 2.1872659 -1069.8265 -1067.6392 - 1300 0.13 0.076457208 5332.4483 66.96652 -1.5226303 2.1553694 -1069.7946 -1067.6392 - 1350 0.135 0.076457225 5441.1287 64.471602 -1.5553539 2.0750686 -1069.7143 -1067.6392 - 1400 0.14 0.076457244 5466.8622 61.292592 -1.5804721 1.9727496 -1069.612 -1067.6392 - 1450 0.145 0.07645724 5403.309 58.518161 -1.6006864 1.8834524 -1069.5227 -1067.6392 - 1500 0.15 0.076457224 5275.2171 57.1713 -1.6196756 1.8401027 -1069.4793 -1067.6392 - 1550 0.155 0.076457217 5122.7481 57.878063 -1.6407322 1.8628504 -1069.5021 -1067.6392 - 1600 0.16 0.076457217 4968.5049 60.639452 -1.6657935 1.9517278 -1069.591 -1067.6392 - 1650 0.165 0.076457208 4850.1861 64.668839 -1.690847 2.0814168 -1069.7206 -1067.6392 - 1700 0.17 0.076457217 4809.0194 68.693586 -1.7087416 2.2109564 -1069.8502 -1067.6392 - 1750 0.175 0.076457274 4835.8611 71.611033 -1.7188587 2.3048567 -1069.9441 -1067.6392 - 1800 0.18 0.076457318 4929.7428 72.815077 -1.7280248 2.3436098 -1069.9828 -1067.6392 - 1850 0.185 0.076457279 5036.6365 72.102335 -1.7426092 2.3206696 -1069.9599 -1067.6392 - 1900 0.19 0.076457222 5116.2436 69.579977 -1.7638235 2.2394856 -1069.8787 -1067.6392 - 1950 0.195 0.076457228 5207.2334 65.715745 -1.7895824 2.1151122 -1069.7543 -1067.6392 - 2000 0.2 0.076457288 5216.0413 61.340972 -1.8174915 1.9743068 -1069.6135 -1067.6392 - 2050 0.205 0.076457267 5023.1601 57.468628 -1.8456914 1.8496724 -1069.4889 -1067.6392 - 2100 0.21 0.076457198 4748.7818 55.033266 -1.8742291 1.7712884 -1069.4105 -1067.6392 - 2150 0.215 0.076457199 4558.1302 54.573806 -1.9035225 1.7565003 -1069.3957 -1067.6392 - 2200 0.22 0.076457185 4483.1644 56.074241 -1.9322669 1.804793 -1069.444 -1067.6392 - 2250 0.225 0.076457114 4430.1583 59.0552 -1.9577399 1.9007374 -1069.54 -1067.6392 - 2300 0.23 0.076457092 4353.7973 62.874849 -1.9801275 2.0236758 -1069.6629 -1067.6392 - 2350 0.235 0.076457145 4303.5275 66.892738 -2.0022129 2.1529947 -1069.7922 -1067.6392 - 2400 0.24 0.076457171 4258.6889 70.426826 -2.0233072 2.2667421 -1069.906 -1067.6392 - 2450 0.245 0.076457169 4178.5775 72.910422 -2.0405304 2.3466785 -1069.9859 -1067.6392 - 2500 0.25 0.07645717 4114.786 74.106367 -2.0531755 2.3851709 -1070.0244 -1067.6392 - 2550 0.255 0.076457136 4067.5017 74.169349 -2.0634674 2.3871981 -1070.0264 -1067.6392 - 2600 0.26 0.076457099 4045.3324 73.586199 -2.0755814 2.3684289 -1070.0077 -1067.6392 - 2650 0.265 0.076457099 4137.898 72.914235 -2.0913646 2.3468012 -1069.986 -1067.6392 - 2700 0.27 0.076457106 4332.063 72.583192 -2.1091075 2.3361464 -1069.9754 -1067.6392 - 2750 0.275 0.07645709 4465.1953 72.814559 -2.125099 2.3435931 -1069.9828 -1067.6392 - 2800 0.28 0.076457051 4516.5192 73.652154 -2.1371914 2.3705517 -1070.0098 -1067.6392 - 2850 0.285 0.076457019 4555.5962 75.060211 -2.1489378 2.4158711 -1070.0551 -1067.6392 - 2900 0.29 0.076457069 4544.2734 76.844795 -2.1667679 2.4733094 -1070.1125 -1067.6392 - 2950 0.295 0.076457172 4460.2109 78.48171 -2.1924421 2.5259948 -1070.1652 -1067.6392 - 3000 0.3 0.076457219 4323.2746 79.20682 -2.2209955 2.549333 -1070.1886 -1067.6392 - 3050 0.305 0.076457213 4155.688 78.543529 -2.2505299 2.5279844 -1070.1672 -1067.6392 - 3100 0.31 0.076457203 3969.6188 76.554785 -2.2858382 2.4639752 -1070.1032 -1067.6392 - 3150 0.315 0.076457187 3761.432 73.396149 -2.3245055 2.362312 -1070.0015 -1067.6392 - 3200 0.32 0.076457142 3602.8035 69.313196 -2.3577056 2.230899 -1069.8701 -1067.6392 - 3250 0.325 0.076457116 3505.707 65.032482 -2.3836874 2.0931209 -1069.7324 -1067.6392 - 3300 0.33 0.07645716 3424.8795 61.551539 -2.4057167 1.9810841 -1069.6203 -1067.6392 - 3350 0.335 0.076457236 3335.9672 59.709703 -2.4251844 1.9218031 -1069.561 -1067.6392 - 3400 0.34 0.076457298 3238.0186 60.026953 -2.4425501 1.9320141 -1069.5712 -1067.6392 - 3450 0.345 0.076457297 3185.0674 62.613739 -2.4593531 2.0152718 -1069.6545 -1067.6392 - 3500 0.35 0.07645723 3197.4087 67.011871 -2.4756907 2.1568291 -1069.7961 -1067.6392 - 3550 0.355 0.076457177 3216.1428 72.316209 -2.4911379 2.3275533 -1069.9668 -1067.6392 - 3600 0.36 0.076457165 3241.0326 77.550071 -2.5083858 2.4960092 -1070.1352 -1067.6392 - 3650 0.365 0.076457168 3309.6874 81.877688 -2.5306273 2.6352969 -1070.2745 -1067.6392 - 3700 0.37 0.07645718 3350.748 84.764646 -2.5595247 2.7282159 -1070.3674 -1067.6392 - 3750 0.375 0.07645721 3368.085 86.031781 -2.5938559 2.7689996 -1070.4082 -1067.6392 - 3800 0.38 0.076457208 3425.3173 85.733048 -2.6266899 2.7593847 -1070.3986 -1067.6392 - 3850 0.385 0.076457165 3420.4429 84.240647 -2.6514805 2.7113506 -1070.3506 -1067.6392 - 3900 0.39 0.076457146 3323.0403 82.320886 -2.6700966 2.6495616 -1070.2888 -1067.6392 - 3950 0.395 0.076457179 3273.2625 80.780607 -2.6892405 2.5999865 -1070.2392 -1067.6392 - 4000 0.4 0.076457229 3313.2671 79.92769 -2.709641 2.5725347 -1070.2118 -1067.6392 - 4050 0.405 0.076457272 3381.1117 79.663389 -2.7291493 2.564028 -1070.2033 -1067.6392 - 4100 0.41 0.07645731 3373.3005 79.895158 -2.7514856 2.5714877 -1070.2107 -1067.6392 - 4150 0.415 0.076457296 3279.6989 80.402828 -2.7788004 2.5878274 -1070.2271 -1067.6392 - 4200 0.42 0.076457251 3197.0478 80.770336 -2.8064773 2.599656 -1070.2389 -1067.6392 - 4250 0.425 0.076457243 3160.9065 80.756747 -2.8307967 2.5992186 -1070.2385 -1067.6392 - 4300 0.43 0.076457282 3173.9599 80.446488 -2.852192 2.5892326 -1070.2285 -1067.6392 - 4350 0.435 0.076457289 3185.8003 80.110494 -2.8726607 2.5784184 -1070.2177 -1067.6392 - 4400 0.44 0.076457262 3166.3054 80.045036 -2.8936787 2.5763116 -1070.2155 -1067.6392 - 4450 0.445 0.076457226 3177.4332 80.500194 -2.9171408 2.5909612 -1070.2302 -1067.6392 - 4500 0.45 0.076457174 3238.8362 81.573722 -2.9447352 2.6255135 -1070.2647 -1067.6392 - 4550 0.455 0.07645714 3277.7104 83.104228 -2.975052 2.6747741 -1070.314 -1067.6392 - 4600 0.46 0.076457157 3224.8571 84.845474 -3.0065552 2.7308174 -1070.37 -1067.6392 - 4650 0.465 0.076457215 3112.9952 86.608217 -3.03972 2.7875527 -1070.4268 -1067.6392 - 4700 0.47 0.076457254 3001.141 88.18732 -3.074928 2.8383773 -1070.4776 -1067.6392 - 4750 0.475 0.076457235 2904.0735 89.204263 -3.1082127 2.8711084 -1070.5103 -1067.6392 - 4800 0.48 0.076457195 2832.0276 89.24571 -3.134302 2.8724424 -1070.5117 -1067.6392 - 4850 0.485 0.076457172 2833.7453 88.206351 -3.1541802 2.8389899 -1070.4782 -1067.6392 - 4900 0.49 0.076457184 2941.993 86.310712 -3.1725372 2.7779773 -1070.4172 -1067.6392 - 4950 0.495 0.076457228 3082.4825 84.029047 -3.1931038 2.7045401 -1070.3438 -1067.6392 - 5000 0.5 0.07645727 3155.7096 81.99875 -3.2175967 2.6391934 -1070.2784 -1067.6392 - 5050 0.505 0.076457297 3162.1875 80.72053 -3.2420202 2.5980529 -1070.2373 -1067.6392 - 5100 0.51 0.076457279 3133.3889 80.483768 -3.2606472 2.5904325 -1070.2297 -1067.6392 - 5150 0.515 0.076457223 3144.6361 81.566513 -3.2759117 2.6252815 -1070.2645 -1067.6392 - 5200 0.52 0.076457166 3156.8183 84.062018 -3.2944729 2.7056013 -1070.3448 -1067.6392 - 5250 0.525 0.076457128 3059.9886 87.694328 -3.3209415 2.82251 -1070.4617 -1067.6392 - 5300 0.53 0.076457126 2891.6506 91.782947 -3.3547324 2.9541054 -1070.5933 -1067.6392 - 5350 0.535 0.076457151 2751.9452 95.417928 -3.3914125 3.0711001 -1070.7103 -1067.6392 - 5400 0.54 0.07645725 2681.0266 97.845096 -3.427665 3.1492204 -1070.7885 -1067.6392 - 5450 0.545 0.076457325 2657.0872 98.736021 -3.4632111 3.1778955 -1070.8171 -1067.6392 - 5500 0.55 0.076457263 2653.1919 98.075728 -3.4957627 3.1566434 -1070.7959 -1067.6392 - 5550 0.555 0.076457185 2644.2052 96.114965 -3.5208827 3.0935347 -1070.7328 -1067.6392 - 5600 0.56 0.076457195 2622.4173 93.52581 -3.5389264 3.0102008 -1070.6494 -1067.6392 - 5650 0.565 0.07645725 2616.385 91.264371 -3.5558734 2.9374146 -1070.5766 -1067.6392 - 5700 0.57 0.076457256 2608.245 90.135398 -3.5771375 2.9010777 -1070.5403 -1067.6392 - 5750 0.575 0.076457193 2573.2163 90.456889 -3.6030063 2.9114252 -1070.5507 -1067.6392 - 5800 0.58 0.076457145 2565.3319 92.099497 -3.6318266 2.9642938 -1070.6035 -1067.6392 - 5850 0.585 0.076457161 2566.2757 94.625315 -3.6627042 3.0455892 -1070.6848 -1067.6392 - 5900 0.59 0.076457186 2564.6803 97.321385 -3.6927592 3.1323643 -1070.7716 -1067.6392 - 5950 0.595 0.076457195 2570.6302 99.384974 -3.7170024 3.1987825 -1070.838 -1067.6392 - 6000 0.6 0.076457206 2556.8451 100.3814 -3.7363623 3.2308531 -1070.8701 -1067.6392 - 6050 0.605 0.076457195 2521.7968 100.35236 -3.7587516 3.2299187 -1070.8692 -1067.6392 - 6100 0.61 0.076457175 2476.1834 99.370379 -3.7869326 3.1983128 -1070.8375 -1067.6392 - 6150 0.615 0.076457178 2397.2793 97.46598 -3.8168635 3.1370182 -1070.7763 -1067.6392 - 6200 0.62 0.07645713 2286.8537 94.931722 -3.8450244 3.0554511 -1070.6947 -1067.6392 - 6250 0.625 0.076457116 2250.5276 92.438472 -3.8722444 2.9752039 -1070.6144 -1067.6392 - 6300 0.63 0.076457156 2338.5273 90.714367 -3.9006127 2.9197123 -1070.5589 -1067.6392 - 6350 0.635 0.07645717 2433.0191 90.142302 -3.9291161 2.9013 -1070.5405 -1067.6392 - 6400 0.64 0.076457159 2467.5427 90.771124 -3.9562695 2.9215391 -1070.5608 -1067.6392 - 6450 0.645 0.076457107 2475.8649 92.488037 -3.9828137 2.9767993 -1070.616 -1067.6392 - 6500 0.65 0.0764571 2489.7445 95.127495 -4.0122155 3.0617523 -1070.701 -1067.6392 - 6550 0.655 0.076457169 2500.4772 98.171784 -4.0419204 3.1597351 -1070.799 -1067.6392 - 6600 0.66 0.076457208 2530.8002 100.74954 -4.0632043 3.2427022 -1070.8819 -1067.6392 - 6650 0.665 0.076457205 2539.1451 102.2625 -4.0743218 3.2913979 -1070.9306 -1067.6392 - 6700 0.67 0.076457193 2456.6604 102.74354 -4.0834224 3.3068807 -1070.9461 -1067.6392 - 6750 0.675 0.076457138 2387.6116 102.56283 -4.0973681 3.3010644 -1070.9403 -1067.6392 - 6800 0.68 0.076457109 2401.109 102.04322 -4.1140004 3.2843402 -1070.9236 -1067.6392 - 6850 0.685 0.076457149 2426.903 101.49411 -4.1282038 3.2666667 -1070.9059 -1067.6392 - 6900 0.69 0.076457185 2389.4414 101.35418 -4.1401788 3.2621629 -1070.9014 -1067.6392 - 6950 0.695 0.076457175 2323.8548 101.97407 -4.1517576 3.2821145 -1070.9213 -1067.6392 - 7000 0.7 0.076457145 2273.8774 103.46341 -4.1630759 3.3300502 -1070.9693 -1067.6392 - 7050 0.705 0.076457126 2231.652 105.807 -4.1769876 3.4054803 -1071.0447 -1067.6392 - 7100 0.71 0.076457114 2185.0532 108.81826 -4.1989101 3.5024002 -1071.1416 -1067.6392 - 7150 0.715 0.076457137 2139.1143 111.85634 -4.2283255 3.6001832 -1071.2394 -1067.6392 - 7200 0.72 0.076457149 2101.4939 113.84909 -4.2559584 3.6643212 -1071.3036 -1067.6392 - 7250 0.725 0.07645712 2118.2862 113.94356 -4.2760809 3.6673619 -1071.3066 -1067.6392 - 7300 0.73 0.076457121 2191.9037 111.95148 -4.2925005 3.6032452 -1071.2425 -1067.6392 - 7350 0.735 0.076457137 2227.2391 108.2126 -4.3103519 3.4829066 -1071.1221 -1067.6392 - 7400 0.74 0.076457111 2182.826 103.4321 -4.3300063 3.3290426 -1070.9683 -1067.6392 - 7450 0.745 0.076457109 2101.7168 98.840049 -4.3541992 3.1812437 -1070.8205 -1067.6392 - 7500 0.75 0.076457149 2036.3108 95.828239 -4.386682 3.0843062 -1070.7235 -1067.6392 - 7550 0.755 0.076457161 1994.4837 95.142177 -4.4221587 3.0622248 -1070.7015 -1067.6392 - 7600 0.76 0.076457127 1970.6785 96.747859 -4.4522387 3.1139049 -1070.7531 -1067.6392 - 7650 0.765 0.076457086 1993.9417 100.15534 -4.4763203 3.2235774 -1070.8628 -1067.6392 - 7700 0.77 0.076457048 2073.7836 104.50424 -4.4979798 3.3635502 -1071.0028 -1067.6392 - 7750 0.775 0.076457026 2168.4033 108.65953 -4.5168753 3.4972912 -1071.1365 -1067.6392 - 7800 0.78 0.07645702 2217.6427 111.71942 -4.5326251 3.5957762 -1071.235 -1067.6392 - 7850 0.785 0.076457017 2202.5357 113.33023 -4.5487958 3.6476215 -1071.2869 -1067.6392 - 7900 0.79 0.076457015 2164.601 113.51362 -4.5690254 3.653524 -1071.2928 -1067.6392 - 7950 0.795 0.076457037 2131.6906 112.46493 -4.5932729 3.6197711 -1071.259 -1067.6392 - 8000 0.8 0.076457042 2076.7626 110.60384 -4.6198371 3.5598705 -1071.1991 -1067.6392 - 8050 0.805 0.07645706 2008.3681 108.69863 -4.6506123 3.4985496 -1071.1378 -1067.6392 - 8100 0.81 0.076457078 1991.1056 107.59889 -4.6874954 3.4631539 -1071.1024 -1067.6392 - 8150 0.815 0.076457081 2030.108 107.96066 -4.7301631 3.4747976 -1071.114 -1067.6392 - 8200 0.82 0.07645709 2053.0781 110.00158 -4.7752612 3.5404861 -1071.1797 -1067.6392 - 8250 0.825 0.076457092 2080.7633 113.42163 -4.8192627 3.650563 -1071.2898 -1067.6392 - 8300 0.83 0.076457092 2136.3278 117.426 -4.8602394 3.7794468 -1071.4187 -1067.6392 - 8350 0.835 0.076457128 2143.1741 120.76905 -4.8928022 3.8870456 -1071.5263 -1067.6392 - 8400 0.84 0.076457182 2096.2614 122.36127 -4.9132303 3.9382923 -1071.5775 -1067.6392 - 8450 0.845 0.076457199 2045.0508 121.81432 -4.9242986 3.9206885 -1071.5599 -1067.6392 - 8500 0.85 0.076457148 1988.55 119.39197 -4.9305717 3.8427231 -1071.482 -1067.6392 - 8550 0.855 0.076457089 1927.6698 115.82938 -4.9366606 3.7280586 -1071.3673 -1067.6392 - 8600 0.86 0.0764571 1904.9377 112.15467 -4.9485473 3.6097852 -1071.249 -1067.6392 - 8650 0.865 0.076457183 1942.1657 109.35829 -4.9712735 3.5197814 -1071.159 -1067.6392 - 8700 0.87 0.076457275 1995.7079 107.97044 -5.0032067 3.4751123 -1071.1143 -1067.6392 - 8750 0.875 0.076457274 2021.2979 107.91844 -5.0351272 3.4734386 -1071.1127 -1067.6392 - 8800 0.88 0.076457159 2019.7716 108.89001 -5.0595657 3.5047095 -1071.1439 -1067.6392 - 8850 0.885 0.076457056 1997.5026 110.65412 -5.0764543 3.5614886 -1071.2007 -1067.6392 - 8900 0.89 0.076457086 1958.2352 113.01816 -5.0898539 3.6375771 -1071.2768 -1067.6392 - 8950 0.895 0.076457184 1948.1688 115.69887 -5.1049282 3.723858 -1071.3631 -1067.6392 - 9000 0.9 0.076457251 1946.4034 118.2422 -5.125187 3.8057169 -1071.4449 -1067.6392 - 9050 0.905 0.076457271 1929.5103 120.07623 -5.1485984 3.8647467 -1071.504 -1067.6392 - 9100 0.91 0.076457223 1920.5823 120.83551 -5.1696144 3.8891848 -1071.5284 -1067.6392 - 9150 0.915 0.07645719 1947.9739 120.53164 -5.1820234 3.8794043 -1071.5186 -1067.6392 - 9200 0.92 0.076457191 2021.9322 119.4904 -5.1820769 3.8458913 -1071.4851 -1067.6392 - 9250 0.925 0.076457189 2120.5676 118.28073 -5.1733083 3.8069571 -1071.4462 -1067.6392 - 9300 0.93 0.076457202 2218.9759 117.51293 -5.1649043 3.7822448 -1071.4215 -1067.6392 - 9350 0.935 0.07645722 2256.6996 117.52636 -5.163384 3.7826772 -1071.4219 -1067.6392 - 9400 0.94 0.076457192 2219.8074 118.22843 -5.1666597 3.8052737 -1071.4445 -1067.6392 - 9450 0.945 0.076457133 2130.6686 119.30164 -5.1680994 3.8398158 -1071.479 -1067.6392 - 9500 0.95 0.076457125 2013.4271 120.65247 -5.1678977 3.8832933 -1071.5225 -1067.6392 - 9550 0.955 0.076457169 1923.3398 122.44923 -5.1747845 3.9411236 -1071.5804 -1067.6392 - 9600 0.96 0.076457205 1913.1904 124.48108 -5.1900088 4.0065202 -1071.6458 -1067.6392 - 9650 0.965 0.076457203 1960.3017 126.09586 -5.2054982 4.0584932 -1071.6977 -1067.6392 - 9700 0.97 0.0764572 1993.4886 126.91655 -5.2204458 4.0849076 -1071.7241 -1067.6392 - 9750 0.975 0.076457237 2016.3395 126.88895 -5.2391789 4.0840193 -1071.7233 -1067.6392 - 9800 0.98 0.076457278 2059.2841 125.9798 -5.2613642 4.0547577 -1071.694 -1067.6392 - 9850 0.985 0.076457268 2076.0892 124.30551 -5.2849423 4.0008692 -1071.6401 -1067.6392 - 9900 0.99 0.076457232 2054.9566 122.26397 -5.3097299 3.9351607 -1071.5744 -1067.6392 - 9950 0.995 0.076457211 2050.2277 120.49535 -5.3384666 3.8782362 -1071.5175 -1067.6392 - 10000 1 0.076457247 2069.6559 119.63397 -5.374562 3.8505122 -1071.4897 -1067.6392 - 10050 1.005 0.076457306 2079.8366 119.92165 -5.4169176 3.8597712 -1071.499 -1067.6392 - 10100 1.01 0.076457317 2051.4213 121.0737 -5.4602428 3.896851 -1071.5361 -1067.6392 - 10150 1.015 0.076457329 2026.2947 122.36851 -5.4975255 3.9385254 -1071.5778 -1067.6392 - 10200 1.02 0.076457353 2042.1162 122.97997 -5.5239278 3.9582059 -1071.5974 -1067.6392 - 10250 1.025 0.076457364 2059.2177 122.42397 -5.5402625 3.9403105 -1071.5795 -1067.6392 - 10300 1.03 0.076457332 2037.1418 120.82131 -5.5531843 3.8887277 -1071.528 -1067.6392 - 10350 1.035 0.076457305 1953.9125 118.75093 -5.5690263 3.8220908 -1071.4613 -1067.6392 - 10400 1.04 0.076457265 1845.8999 116.97821 -5.5872522 3.7650343 -1071.4043 -1067.6392 - 10450 1.045 0.076457218 1789.9704 116.44416 -5.6054265 3.7478455 -1071.3871 -1067.6392 - 10500 1.05 0.076457227 1790.1722 117.85441 -5.6201726 3.7932355 -1071.4325 -1067.6392 - 10550 1.055 0.076457265 1792.8951 121.26237 -5.6302348 3.9029234 -1071.5422 -1067.6392 - 10600 1.06 0.076457285 1801.2253 126.08926 -5.6408443 4.0582808 -1071.6975 -1067.6392 - 10650 1.065 0.076457276 1848.312 131.30844 -5.6585268 4.2262642 -1071.8655 -1067.6392 - 10700 1.07 0.076457228 1899.189 135.63605 -5.6833 4.3655515 -1072.0048 -1067.6392 - 10750 1.075 0.076457196 1933.4466 137.94816 -5.7116789 4.4399687 -1072.0792 -1067.6392 - 10800 1.08 0.076457209 1952.1407 137.53149 -5.7380474 4.4265577 -1072.0658 -1067.6392 - 10850 1.085 0.076457232 1956.2467 134.36784 -5.7597709 4.3247333 -1071.964 -1067.6392 - 10900 1.09 0.076457254 1935.3183 129.23046 -5.7778262 4.1593827 -1071.7986 -1067.6392 - 10950 1.095 0.07645725 1894.1382 123.56602 -5.7940915 3.9770683 -1071.6163 -1067.6392 - 11000 1.1 0.076457202 1869.9315 119.13104 -5.8115801 3.8343249 -1071.4736 -1067.6392 - 11050 1.105 0.076457157 1872.2105 117.1706 -5.8302554 3.7712266 -1071.4105 -1067.6392 - 11100 1.11 0.076457121 1910.0087 117.93509 -5.8479403 3.7958325 -1071.4351 -1067.6392 - 11150 1.115 0.076457111 1974.5822 120.8604 -5.8628947 3.8899857 -1071.5292 -1067.6392 - 11200 1.12 0.076457152 2017.5386 125.16424 -5.8764671 4.0285084 -1071.6677 -1067.6392 - 11250 1.125 0.076457215 2006.1464 130.14791 -5.8926588 4.1889116 -1071.8281 -1067.6392 - 11300 1.13 0.076457208 1981.6806 134.97307 -5.9111129 4.344213 -1071.9834 -1067.6392 - 11350 1.135 0.076457154 1955.8911 138.78712 -5.9293384 4.4669713 -1072.1062 -1067.6392 - 11400 1.14 0.076457103 1903.025 141.01634 -5.9477992 4.5387205 -1072.178 -1067.6392 - 11450 1.145 0.076457082 1861.8231 141.41934 -5.9709229 4.5516912 -1072.1909 -1067.6392 - 11500 1.15 0.076457105 1864.1 139.85754 -5.999873 4.5014233 -1072.1407 -1067.6392 - 11550 1.155 0.076457135 1864.553 136.29668 -6.0269465 4.3868144 -1072.026 -1067.6392 - 11600 1.16 0.076457167 1838.5238 131.42789 -6.0482365 4.2301086 -1071.8693 -1067.6392 - 11650 1.165 0.076457207 1805.0176 126.80497 -6.0718009 4.0813163 -1071.7205 -1067.6392 - 11700 1.17 0.076457247 1735.2577 124.00212 -6.1059505 3.9911044 -1071.6303 -1067.6392 - 11750 1.175 0.076457255 1641.4793 123.80317 -6.1481291 3.984701 -1071.6239 -1067.6392 - 11800 1.18 0.076457236 1596.2043 126.199 -6.1904504 4.0618126 -1071.701 -1067.6392 - 11850 1.185 0.076457229 1622.0725 130.64719 -6.2272702 4.2049812 -1071.8442 -1067.6392 - 11900 1.19 0.076457283 1669.7039 136.11282 -6.2551373 4.3808969 -1072.0201 -1067.6392 - 11950 1.195 0.076457361 1687.4469 141.27818 -6.2753897 4.5471478 -1072.1864 -1067.6392 - 12000 1.2 0.076457336 1685.355 144.8526 -6.294312 4.6621933 -1072.3014 -1067.6392 - 12050 1.205 0.076457364 1684.0235 145.75585 -6.3137437 4.691265 -1072.3305 -1067.6392 - 12100 1.21 0.076457364 1695.7222 143.63233 -6.3312278 4.6229181 -1072.2622 -1067.6392 - 12150 1.215 0.076457301 1744.0573 139.27223 -6.3471908 4.4825848 -1072.1218 -1067.6392 - 12200 1.22 0.076457264 1815.5391 134.28007 -6.3640171 4.3219083 -1071.9611 -1067.6392 - 12250 1.225 0.076457306 1839.4868 130.2409 -6.378914 4.1919044 -1071.8311 -1067.6392 - 12300 1.23 0.076457381 1791.3388 128.29684 -6.3893167 4.1293333 -1071.7686 -1067.6392 - 12350 1.235 0.076457382 1713.284 129.07652 -6.4002273 4.154428 -1071.7937 -1067.6392 - 12400 1.24 0.076457352 1639.3792 132.52697 -6.4176635 4.2654835 -1071.9047 -1067.6392 - 12450 1.245 0.076457344 1579.8725 137.81757 -6.4424211 4.4357656 -1072.075 -1067.6392 - 12500 1.25 0.076457303 1557.3644 143.52235 -6.4729454 4.6193783 -1072.2586 -1067.6392 - 12550 1.255 0.076457277 1618.5087 148.11444 -6.5082137 4.7671782 -1072.4064 -1067.6392 - 12600 1.26 0.076457326 1720.3013 150.5465 -6.5476118 4.845456 -1072.4847 -1067.6392 - 12650 1.265 0.076457391 1778.5404 150.56002 -6.5906298 4.8458912 -1072.4851 -1067.6392 - 12700 1.27 0.076457351 1788.5951 148.56554 -6.6347601 4.7816972 -1072.4209 -1067.6392 - 12750 1.275 0.076457269 1779.1884 145.24576 -6.6730452 4.6748475 -1072.3141 -1067.6392 - 12800 1.28 0.07645728 1758.2949 141.40165 -6.701303 4.5511219 -1072.1904 -1067.6392 - 12850 1.285 0.076457312 1712.5641 137.9123 -6.7240908 4.4388145 -1072.078 -1067.6392 - 12900 1.29 0.076457327 1668.6646 135.42155 -6.7444763 4.3586478 -1071.9979 -1067.6392 - 12950 1.295 0.076457332 1653.7008 134.40911 -6.7622343 4.3260615 -1071.9653 -1067.6392 - 13000 1.3 0.076457334 1678.1215 135.3964 -6.7808215 4.3578383 -1071.9971 -1067.6392 - 13050 1.305 0.076457316 1709.6866 138.43433 -6.7994699 4.4556163 -1072.0948 -1067.6392 - 13100 1.31 0.076457256 1719.9198 142.81982 -6.8124215 4.5967668 -1072.236 -1067.6392 - 13150 1.315 0.076457227 1716.5741 147.42301 -6.8192217 4.744924 -1072.3842 -1067.6392 - 13200 1.32 0.076457238 1743.2587 150.89049 -6.8222296 4.8565276 -1072.4958 -1067.6392 - 13250 1.325 0.076457261 1793.7636 151.98662 -6.8200794 4.8918073 -1072.531 -1067.6392 - 13300 1.33 0.07645729 1825.2569 150.42643 -6.8140605 4.8415915 -1072.4808 -1067.6392 - 13350 1.335 0.076457252 1838.476 147.28172 -6.8146446 4.7403765 -1072.3796 -1067.6392 - 13400 1.34 0.076457169 1838.3398 144.11825 -6.8303357 4.6385577 -1072.2778 -1067.6392 - 13450 1.345 0.076457222 1801.0039 141.93725 -6.8583491 4.5683605 -1072.2076 -1067.6392 - 13500 1.35 0.076457347 1755.582 140.99498 -6.89022 4.5380327 -1072.1773 -1067.6392 - 13550 1.355 0.076457427 1733.1918 141.21311 -6.9214427 4.5450535 -1072.1843 -1067.6392 - 13600 1.36 0.076457431 1712.5682 142.19629 -6.9465697 4.5766981 -1072.2159 -1067.6392 - 13650 1.365 0.076457399 1717.694 143.5117 -6.9629204 4.6190353 -1072.2583 -1067.6392 - 13700 1.37 0.076457334 1770.8346 145.13001 -6.9802142 4.671122 -1072.3104 -1067.6392 - 13750 1.375 0.076457247 1825.1073 146.95312 -7.0064861 4.7298002 -1072.369 -1067.6392 - 13800 1.38 0.076457256 1824.3539 148.48573 -7.0381068 4.7791285 -1072.4184 -1067.6392 - 13850 1.385 0.076457313 1782.7326 149.20301 -7.0651441 4.8022147 -1072.4414 -1067.6392 - 13900 1.39 0.076457295 1750.9167 149.18894 -7.0840385 4.8017618 -1072.441 -1067.6392 - 13950 1.395 0.076457288 1760.1963 149.12388 -7.1020342 4.7996679 -1072.4389 -1067.6392 - 14000 1.4 0.076457265 1776.4309 149.46795 -7.1245024 4.8107421 -1072.45 -1067.6392 - 14050 1.405 0.076457201 1795.0829 150.25585 -7.1514213 4.8361011 -1072.4753 -1067.6392 - 14100 1.41 0.076457229 1812.6337 151.48841 -7.1831839 4.8757722 -1072.515 -1067.6392 - 14150 1.415 0.076457297 1801.8728 153.13675 -7.2174201 4.928825 -1072.5681 -1067.6392 - 14200 1.42 0.076457305 1773.4672 155.06508 -7.2481606 4.9908901 -1072.6301 -1067.6392 - 14250 1.425 0.076457282 1738.9317 157.04135 -7.2698182 5.0544977 -1072.6937 -1067.6392 - 14300 1.43 0.076457306 1716.5389 158.77479 -7.2837833 5.1102898 -1072.7495 -1067.6392 - 14350 1.435 0.07645735 1720.7949 159.7069 -7.2945528 5.1402904 -1072.7795 -1067.6392 - 14400 1.44 0.076457333 1748.7885 159.02986 -7.3011362 5.1184995 -1072.7577 -1067.6392 - 14450 1.445 0.076457295 1742.8885 156.42679 -7.3047662 5.0347176 -1072.674 -1067.6392 - 14500 1.45 0.076457256 1670.5068 152.24569 -7.3102428 4.9001455 -1072.5394 -1067.6392 - 14550 1.455 0.076457265 1584.5241 147.05373 -7.318176 4.7330384 -1072.3723 -1067.6392 - 14600 1.46 0.076457287 1529.9826 141.71242 -7.3290619 4.5611241 -1072.2004 -1067.6392 - 14650 1.465 0.076457308 1510.2873 137.60969 -7.3489824 4.4290747 -1072.0683 -1067.6392 - 14700 1.47 0.076457333 1517.9737 136.06432 -7.3778607 4.3793359 -1072.0186 -1067.6392 - 14750 1.475 0.076457349 1536.5785 137.7444 -7.4074887 4.4334105 -1072.0726 -1067.6392 - 14800 1.48 0.076457332 1570.427 142.60265 -7.435251 4.589777 -1072.229 -1067.6392 - 14850 1.485 0.076457277 1605.5273 149.55383 -7.4584362 4.813506 -1072.4527 -1067.6392 - 14900 1.49 0.076457286 1619.5816 156.68247 -7.4687128 5.042947 -1072.6822 -1067.6392 - 14950 1.495 0.076457352 1628.8798 162.48759 -7.4692532 5.2297891 -1072.869 -1067.6392 - 15000 1.5 0.076457367 1645.2779 166.28468 -7.4710214 5.3520015 -1072.9912 -1067.6392 - 15050 1.505 0.076457354 1659.3085 168.01268 -7.4835147 5.4076185 -1073.0469 -1067.6392 - 15100 1.51 0.076457322 1657.5151 167.8691 -7.5090057 5.4029973 -1073.0422 -1067.6392 - 15150 1.515 0.076457334 1619.1825 165.90116 -7.5343027 5.3396576 -1072.9789 -1067.6392 - 15200 1.52 0.076457345 1564.833 162.54809 -7.5475534 5.2317363 -1072.871 -1067.6392 - 15250 1.525 0.076457333 1526.2301 158.9992 -7.5544031 5.1175126 -1072.7567 -1067.6392 - 15300 1.53 0.076457299 1516.6129 156.42636 -7.5677145 5.0347037 -1072.6739 -1067.6392 - 15350 1.535 0.07645727 1514.4631 155.10745 -7.5910984 4.9922537 -1072.6315 -1067.6392 - 15400 1.54 0.076457295 1489.0219 154.49939 -7.6168589 4.9726826 -1072.6119 -1067.6392 - 15450 1.545 0.076457307 1454.98 154.09722 -7.6374985 4.9597386 -1072.599 -1067.6392 - 15500 1.55 0.076457289 1465.2041 153.94567 -7.6532363 4.9548609 -1072.5941 -1067.6392 - 15550 1.555 0.076457258 1507.1468 154.2404 -7.6663203 4.964347 -1072.6036 -1067.6392 - 15600 1.56 0.076457196 1529.3808 154.91397 -7.6776911 4.9860264 -1072.6253 -1067.6392 - 15650 1.565 0.076457177 1523.9817 156.0119 -7.695343 5.021364 -1072.6606 -1067.6392 - 15700 1.57 0.076457193 1522.7643 157.82491 -7.7296805 5.0797172 -1072.7189 -1067.6392 - 15750 1.575 0.076457243 1494.5697 160.297 -7.7768073 5.1592832 -1072.7985 -1067.6392 - 15800 1.58 0.076457287 1432.4424 162.81609 -7.8203339 5.2403621 -1072.8796 -1067.6392 - 15850 1.585 0.07645733 1402.4977 164.59576 -7.8451116 5.2976423 -1072.9369 -1067.6392 - 15900 1.59 0.076457402 1416.812 165.26647 -7.8504137 5.3192297 -1072.9585 -1067.6392 - 15950 1.595 0.076457391 1434.0052 165.00555 -7.8513437 5.3108318 -1072.9501 -1067.6392 - 16000 1.6 0.07645732 1448.028 163.9183 -7.8607479 5.2758378 -1072.9151 -1067.6392 - 16050 1.605 0.076457324 1476.1802 161.67871 -7.8741051 5.2037547 -1072.843 -1067.6392 - 16100 1.61 0.076457365 1517.1195 158.257 -7.8821118 5.0936245 -1072.7329 -1067.6392 - 16150 1.615 0.07645732 1551.8013 154.48554 -7.8845021 4.9722371 -1072.6115 -1067.6392 - 16200 1.62 0.076457224 1563.4592 151.61692 -7.8867696 4.8799081 -1072.5191 -1067.6392 - 16250 1.625 0.076457231 1568.8982 150.52413 -7.8928325 4.8447358 -1072.484 -1067.6392 - 16300 1.63 0.076457315 1587.8208 151.31592 -7.9028799 4.8702203 -1072.5095 -1067.6392 - 16350 1.635 0.076457401 1587.1658 153.58503 -7.9155357 4.9432533 -1072.5825 -1067.6392 - 16400 1.64 0.0764574 1564.8466 156.97281 -7.9329671 5.0522917 -1072.6915 -1067.6392 - 16450 1.645 0.076457324 1559.9515 161.25392 -7.9569659 5.1900827 -1072.8293 -1067.6392 - 16500 1.65 0.07645729 1572.1491 166.16033 -7.9871415 5.3479991 -1072.9872 -1067.6392 - 16550 1.655 0.076457319 1587.1041 171.09675 -8.0223182 5.5068818 -1073.1461 -1067.6392 - 16600 1.66 0.076457367 1611.2738 175.10798 -8.0612322 5.6359861 -1073.2752 -1067.6392 - 16650 1.665 0.076457363 1645.197 177.28144 -8.100579 5.7059409 -1073.3452 -1067.6392 - 16700 1.67 0.076457373 1687.596 177.10275 -8.1330656 5.7001896 -1073.3394 -1067.6392 - 16750 1.675 0.076457406 1741.0657 174.63626 -8.1549243 5.6208035 -1073.26 -1067.6392 - 16800 1.68 0.076457428 1770.5295 170.6939 -8.1775588 5.4939157 -1073.1331 -1067.6392 - 16850 1.685 0.076457412 1764.9164 166.35555 -8.2116214 5.3542824 -1072.9935 -1067.6392 - 16900 1.69 0.076457377 1753.4555 162.46345 -8.24703 5.2290123 -1072.8682 -1067.6392 - 16950 1.695 0.076457382 1737.3044 159.85392 -8.2679658 5.1450224 -1072.7843 -1067.6392 - 17000 1.7 0.076457397 1698.4267 159.38372 -8.2771546 5.1298887 -1072.7691 -1067.6392 - 17050 1.705 0.076457398 1648.5432 161.02257 -8.2829365 5.1826363 -1072.8219 -1067.6392 - 17100 1.71 0.076457362 1597.8104 163.90303 -8.2883924 5.2753461 -1072.9146 -1067.6392 - 17150 1.715 0.076457407 1581.3305 167.13768 -8.2982879 5.3794559 -1073.0187 -1067.6392 - 17200 1.72 0.076457416 1615.3538 169.91691 -8.3147181 5.4689075 -1073.1081 -1067.6392 - 17250 1.725 0.076457317 1640.517 171.76528 -8.3382653 5.5283989 -1073.1676 -1067.6392 - 17300 1.73 0.076457279 1642.0824 172.72393 -8.3672834 5.5592538 -1073.1985 -1067.6392 - 17350 1.735 0.076457358 1654.7782 173.20812 -8.3956352 5.5748377 -1073.2141 -1067.6392 - 17400 1.74 0.076457387 1690.9444 174.02756 -8.4250034 5.6012122 -1073.2404 -1067.6392 - 17450 1.745 0.076457318 1700.9667 175.61591 -8.4582001 5.6523344 -1073.2916 -1067.6392 - 17500 1.75 0.076457288 1647.3737 177.46686 -8.4919066 5.7119087 -1073.3511 -1067.6392 - 17550 1.755 0.076457298 1540.9506 178.64086 -8.5244634 5.7496947 -1073.3889 -1067.6392 - 17600 1.76 0.076457329 1446.6813 178.43003 -8.554886 5.7429089 -1073.3821 -1067.6392 - 17650 1.765 0.076457379 1412.0895 176.95558 -8.5854884 5.6954528 -1073.3347 -1067.6392 - 17700 1.77 0.076457349 1414.559 175.0213 -8.6219735 5.6331963 -1073.2724 -1067.6392 - 17750 1.775 0.076457246 1413.6264 173.04798 -8.6573217 5.5696835 -1073.2089 -1067.6392 - 17800 1.78 0.076457222 1399.031 170.80066 -8.673405 5.4973518 -1073.1366 -1067.6392 - 17850 1.785 0.076457257 1402.9589 168.32364 -8.6692442 5.417627 -1073.0569 -1067.6392 - 17900 1.79 0.076457292 1421.4914 166.26754 -8.667908 5.3514498 -1072.9907 -1067.6392 - 17950 1.795 0.07645729 1459.6161 165.06532 -8.6883597 5.3127556 -1072.952 -1067.6392 - 18000 1.8 0.07645728 1526.0272 164.4467 -8.724083 5.2928448 -1072.9321 -1067.6392 - 18050 1.805 0.076457285 1579.053 164.14599 -8.7580049 5.283166 -1072.9224 -1067.6392 - 18100 1.81 0.076457295 1585.8299 164.68311 -8.7876471 5.3004537 -1072.9397 -1067.6392 - 18150 1.815 0.076457311 1571.4213 167.11719 -8.82749 5.3787965 -1073.018 -1067.6392 - 18200 1.82 0.076457253 1566.7735 171.84493 -8.8828984 5.5309623 -1073.1702 -1067.6392 - 18250 1.825 0.076457211 1565.9409 178.03402 -8.9379169 5.7301632 -1073.3694 -1067.6392 - 18300 1.83 0.076457261 1564.3982 184.19934 -8.977693 5.9285986 -1073.5678 -1067.6392 - 18350 1.835 0.07645725 1565.4674 188.93147 -9.0068361 6.0809061 -1073.7201 -1067.6392 - 18400 1.84 0.076457214 1575.9469 191.19229 -9.0319747 6.1536724 -1073.7929 -1067.6392 - 18450 1.845 0.076457289 1591.7212 190.75232 -9.0530056 6.1395115 -1073.7787 -1067.6392 - 18500 1.85 0.076457356 1602.2968 188.42238 -9.0750081 6.0645207 -1073.7038 -1067.6392 - 18550 1.855 0.076457289 1601.939 185.22419 -9.1006094 5.9615844 -1073.6008 -1067.6392 - 18600 1.86 0.076457199 1571.9204 181.88092 -9.1245655 5.8539786 -1073.4932 -1067.6392 - 18650 1.865 0.076457174 1547.9534 179.20735 -9.1468721 5.7679277 -1073.4072 -1067.6392 - 18700 1.87 0.076457165 1552.3316 177.96057 -9.1713552 5.7277992 -1073.367 -1067.6392 - 18750 1.875 0.076457197 1553.5318 178.2992 -9.1953424 5.7386981 -1073.3779 -1067.6392 - 18800 1.88 0.076457184 1502.7768 179.82752 -9.2133625 5.7878883 -1073.4271 -1067.6392 - 18850 1.885 0.076457121 1411.167 181.98955 -9.226772 5.857475 -1073.4967 -1067.6392 - 18900 1.89 0.07645718 1331.5599 184.25555 -9.244306 5.9304078 -1073.5696 -1067.6392 - 18950 1.895 0.076457306 1300.8838 185.96704 -9.269864 5.9854936 -1073.6247 -1067.6392 - 19000 1.9 0.076457332 1341.3268 186.45142 -9.2968684 6.0010837 -1073.6403 -1067.6392 - 19050 1.905 0.076457294 1418.9495 185.73025 -9.3201217 5.9778722 -1073.6171 -1067.6392 - 19100 1.91 0.076457261 1469.3348 184.71078 -9.3405594 5.9450597 -1073.5843 -1067.6392 - 19150 1.915 0.07645726 1494.8858 184.40838 -9.3593456 5.9353267 -1073.5746 -1067.6392 - 19200 1.92 0.076457302 1535.9214 185.12696 -9.3754395 5.958455 -1073.5977 -1067.6392 - 19250 1.925 0.076457322 1578.5937 186.7022 -9.3955891 6.0091552 -1073.6484 -1067.6392 - 19300 1.93 0.07645736 1578.7452 188.80101 -9.4323472 6.076707 -1073.7159 -1067.6392 - 19350 1.935 0.076457464 1549.5413 190.55677 -9.4860328 6.1332175 -1073.7725 -1067.6392 - 19400 1.94 0.076457401 1518.0105 190.8838 -9.545051 6.1437434 -1073.783 -1067.6392 - 19450 1.945 0.076457226 1476.9524 189.41845 -9.6005799 6.0965799 -1073.7358 -1067.6392 - 19500 1.95 0.076457236 1453.8032 186.8834 -9.6531215 6.0149872 -1073.6542 -1067.6392 - 19550 1.955 0.076457309 1436.5876 184.62159 -9.7075641 5.942189 -1073.5814 -1067.6392 - 19600 1.96 0.076457314 1395.5458 183.83049 -9.7642712 5.9167271 -1073.556 -1067.6392 - 19650 1.965 0.076457309 1342.194 185.07394 -9.8173107 5.9567485 -1073.596 -1067.6392 - 19700 1.97 0.076457382 1296.9221 188.42121 -9.866389 6.0644829 -1073.7037 -1067.6392 - 19750 1.975 0.076457367 1284.6809 193.29911 -9.9107399 6.2214817 -1073.8607 -1067.6392 - 19800 1.98 0.076457239 1277.2922 198.66316 -9.946204 6.3941279 -1074.0334 -1067.6392 - 19850 1.985 0.076457182 1240.7957 203.40147 -9.9754722 6.5466343 -1074.1859 -1067.6392 - 19900 1.99 0.07645726 1203.1195 206.12078 -10.001353 6.6341571 -1074.2734 -1067.6392 - 19950 1.995 0.076457363 1202.7274 205.68644 -10.025039 6.6201776 -1074.2594 -1067.6392 - 20000 2 0.076457341 1220.191 202.20273 -10.047292 6.5080517 -1074.1473 -1067.6392 - 20050 2.005 0.076457241 1219.9293 197.12841 -10.066398 6.3447308 -1073.984 -1067.6392 - 20100 2.01 0.076457168 1194.4117 192.23758 -10.079101 6.1873157 -1073.8265 -1067.6392 - 20150 2.015 0.076457198 1169.6328 188.78101 -10.085348 6.0760632 -1073.7153 -1067.6392 - 20200 2.02 0.076457237 1170.2112 187.39597 -10.084836 6.0314848 -1073.6707 -1067.6392 - 20250 2.025 0.076457263 1178.3781 188.35798 -10.080252 6.0624476 -1073.7017 -1067.6392 - 20300 2.03 0.076457263 1193.5136 191.43468 -10.076517 6.1614738 -1073.8007 -1067.6392 - 20350 2.035 0.076457217 1217.151 195.69411 -10.073155 6.2985667 -1073.9378 -1067.6392 - 20400 2.04 0.076457203 1235.3327 200.1109 -10.073615 6.4407245 -1074.08 -1067.6392 - 20450 2.045 0.076457254 1242.9155 203.63993 -10.081258 6.5543091 -1074.1935 -1067.6392 - 20500 2.05 0.076457271 1241.9055 205.2779 -10.095394 6.6070286 -1074.2463 -1067.6392 - 20550 2.055 0.076457271 1221.6949 204.56884 -10.116586 6.5842068 -1074.2234 -1067.6392 - 20600 2.06 0.076457294 1226.6359 201.68982 -10.144389 6.4915433 -1074.1308 -1067.6392 - 20650 2.065 0.07645732 1283.4482 197.23304 -10.174916 6.3480985 -1073.9873 -1067.6392 - 20700 2.07 0.076457316 1329.13 192.42022 -10.208859 6.1931942 -1073.8324 -1067.6392 - 20750 2.075 0.076457251 1326.0056 189.01786 -10.251588 6.0836867 -1073.7229 -1067.6392 - 20800 2.08 0.076457224 1289.0675 188.31447 -10.298492 6.0610474 -1073.7003 -1067.6392 - 20850 2.085 0.076457272 1261.4039 190.77218 -10.344257 6.1401507 -1073.7794 -1067.6392 - 20900 2.09 0.076457341 1274.4048 195.96512 -10.390177 6.3072895 -1073.9465 -1067.6392 - 20950 2.095 0.076457382 1294.6179 202.31796 -10.42989 6.5117606 -1074.151 -1067.6392 - 21000 2.1 0.076457336 1271.5204 207.81694 -10.451365 6.6887496 -1074.328 -1067.6392 - 21050 2.105 0.076457218 1224.8924 211.49094 -10.462946 6.8070002 -1074.4462 -1067.6392 - 21100 2.11 0.076457179 1197.0124 213.27369 -10.482662 6.8643792 -1074.5036 -1067.6392 - 21150 2.115 0.076457232 1200.2169 213.01628 -10.509071 6.8560942 -1074.4953 -1067.6392 - 21200 2.12 0.076457334 1233.3373 211.01674 -10.539776 6.7917377 -1074.431 -1067.6392 - 21250 2.125 0.076457324 1292.2293 208.23361 -10.582784 6.7021603 -1074.3414 -1067.6392 - 21300 2.13 0.076457234 1353.0348 205.33718 -10.632972 6.6089366 -1074.2482 -1067.6392 - 21350 2.135 0.076457274 1390.9107 202.43255 -10.667402 6.5154488 -1074.1547 -1067.6392 - 21400 2.14 0.076457309 1398.7408 199.69704 -10.670157 6.4274041 -1074.0666 -1067.6392 - 21450 2.145 0.076457306 1400.5231 197.71241 -10.646924 6.3635274 -1074.0028 -1067.6392 - 21500 2.15 0.076457319 1422.7259 197.36253 -10.618311 6.3522661 -1073.9915 -1067.6392 - 21550 2.155 0.076457297 1434.7766 199.14128 -10.598724 6.4095165 -1074.0487 -1067.6392 - 21600 2.16 0.076457278 1429.5442 202.52793 -10.589548 6.5185185 -1074.1577 -1067.6392 - 21650 2.165 0.076457295 1420.497 206.1935 -10.591701 6.636498 -1074.2757 -1067.6392 - 21700 2.17 0.076457276 1378.0825 208.36958 -10.599065 6.7065365 -1074.3458 -1067.6392 - 21750 2.175 0.076457297 1325.5891 208.06821 -10.604715 6.6968368 -1074.3361 -1067.6392 - 21800 2.18 0.076457341 1286.1379 205.87017 -10.612217 6.6260911 -1074.2653 -1067.6392 - 21850 2.185 0.076457343 1249.4394 203.00417 -10.618963 6.5338467 -1074.1731 -1067.6392 - 21900 2.19 0.076457342 1219.6068 200.92404 -10.618829 6.4668963 -1074.1061 -1067.6392 - 21950 2.195 0.076457255 1203.2091 201.06239 -10.615316 6.4713491 -1074.1106 -1067.6392 - 22000 2.2 0.076457157 1207.2707 203.83245 -10.616122 6.5605055 -1074.1997 -1067.6392 - 22050 2.205 0.076457174 1213.7955 208.32753 -10.627885 6.7051832 -1074.3444 -1067.6392 - 22100 2.21 0.076457305 1217.4318 212.84143 -10.652913 6.8504667 -1074.4897 -1067.6392 - 22150 2.215 0.076457345 1210.5327 215.5321 -10.688094 6.9370678 -1074.5763 -1067.6392 - 22200 2.22 0.076457215 1195.2458 215.20969 -10.73343 6.9266909 -1074.5659 -1067.6392 - 22250 2.225 0.076457077 1182.8507 211.73156 -10.788326 6.8147447 -1074.454 -1067.6392 - 22300 2.23 0.076457075 1161.1546 206.13732 -10.841515 6.6346895 -1074.2739 -1067.6392 - 22350 2.235 0.076457134 1136.2879 200.67718 -10.880177 6.4589508 -1074.0982 -1067.6392 - 22400 2.24 0.07645722 1141.1588 197.90394 -10.902196 6.369692 -1074.0089 -1067.6392 - 22450 2.245 0.07645725 1183.4596 199.22083 -10.913175 6.412077 -1074.0513 -1067.6392 - 22500 2.25 0.076457199 1229.4238 204.41082 -10.921755 6.5791208 -1074.2184 -1067.6392 - 22550 2.255 0.076457171 1264.902 212.14836 -10.939819 6.8281595 -1074.4674 -1067.6392 - 22600 2.26 0.076457158 1287.9026 220.33991 -10.971089 7.091811 -1074.731 -1067.6392 - 22650 2.265 0.076457207 1311.4828 226.7258 -11.007167 7.2973458 -1074.9366 -1067.6392 - 22700 2.27 0.076457319 1353.9253 229.84218 -11.040634 7.3976489 -1075.0369 -1067.6392 - 22750 2.275 0.076457274 1390.1174 229.24441 -11.068644 7.3784091 -1075.0176 -1067.6392 - 22800 2.28 0.076457156 1387.0664 225.36499 -11.095325 7.2535471 -1074.8928 -1067.6392 - 22850 2.285 0.076457176 1360.9519 219.18675 -11.130488 7.0546956 -1074.6939 -1067.6392 - 22900 2.29 0.076457316 1344.359 211.76274 -11.174978 6.8157482 -1074.455 -1067.6392 - 22950 2.295 0.07645732 1299.3984 204.35647 -11.214963 6.5773717 -1074.2166 -1067.6392 - 23000 2.3 0.076457162 1231.7571 198.93484 -11.2383 6.4028722 -1074.0421 -1067.6392 - 23050 2.305 0.07645712 1199.0791 197.45133 -11.245595 6.3551243 -1073.9944 -1067.6392 - 23100 2.31 0.076457206 1194.5403 200.36018 -11.246069 6.4487479 -1074.088 -1067.6392 - 23150 2.315 0.07645717 1213.0855 206.27572 -11.249945 6.6391441 -1074.2784 -1067.6392 - 23200 2.32 0.076457149 1247.0389 212.62317 -11.25317 6.8434419 -1074.4827 -1067.6392 - 23250 2.325 0.076457232 1252.9771 217.14066 -11.243809 6.9888406 -1074.6281 -1067.6392 - 23300 2.33 0.076457298 1246.3963 219.5467 -11.230203 7.0662811 -1074.7055 -1067.6392 - 23350 2.335 0.076457347 1263.8532 220.90621 -11.226826 7.1100378 -1074.7493 -1067.6392 - 23400 2.34 0.076457343 1278.9193 222.02245 -11.231757 7.1459649 -1074.7852 -1067.6392 - 23450 2.345 0.076457298 1271.4615 223.28544 -11.242585 7.1866153 -1074.8258 -1067.6392 - 23500 2.35 0.076457216 1263.4764 224.76526 -11.261772 7.2342444 -1074.8735 -1067.6392 - 23550 2.355 0.076457156 1269.5953 225.95356 -11.284145 7.2724905 -1074.9117 -1067.6392 - 23600 2.36 0.076457239 1268.359 226.26773 -11.305282 7.2826025 -1074.9218 -1067.6392 - 23650 2.365 0.076457257 1265.5906 225.69913 -11.3327 7.2643016 -1074.9035 -1067.6392 - 23700 2.37 0.076457123 1275.7614 224.53597 -11.374051 7.2268646 -1074.8661 -1067.6392 - 23750 2.375 0.076457085 1287.3169 222.75095 -11.424079 7.1694122 -1074.8086 -1067.6392 - 23800 2.38 0.076457174 1303.4659 219.83945 -11.467156 7.0757035 -1074.7149 -1067.6392 - 23850 2.385 0.076457349 1312.2776 215.4104 -11.491657 6.9331509 -1074.5724 -1067.6392 - 23900 2.39 0.076457447 1300.2196 210.22181 -11.505842 6.766152 -1074.4054 -1067.6392 - 23950 2.395 0.076457318 1285.3883 205.91466 -11.523034 6.6275231 -1074.2668 -1067.6392 - 24000 2.4 0.076457215 1271.3069 203.89116 -11.544141 6.5623954 -1074.2016 -1067.6392 - 24050 2.405 0.07645717 1275.6297 204.82158 -11.568504 6.5923414 -1074.2316 -1067.6392 - 24100 2.41 0.076457155 1308.5278 208.28691 -11.593169 6.703876 -1074.3431 -1067.6392 - 24150 2.415 0.076457173 1320.3939 213.14435 -11.610405 6.8602164 -1074.4994 -1067.6392 - 24200 2.42 0.076457286 1290.2677 218.34701 -11.616172 7.0276681 -1074.6669 -1067.6392 - 24250 2.425 0.07645742 1266.5534 223.16759 -11.612622 7.182822 -1074.8221 -1067.6392 - 24300 2.43 0.076457424 1263.1458 227.14553 -11.607449 7.310855 -1074.9501 -1067.6392 - 24350 2.435 0.076457322 1278.3394 229.88879 -11.606753 7.3991491 -1075.0384 -1067.6392 - 24400 2.44 0.076457217 1299.8856 231.18375 -11.60862 7.4408286 -1075.0801 -1067.6392 - 24450 2.445 0.076457261 1314.6037 231.51695 -11.609751 7.4515526 -1075.0908 -1067.6392 - 24500 2.45 0.076457395 1306.5195 231.80528 -11.609243 7.4608328 -1075.1001 -1067.6392 - 24550 2.455 0.076457379 1284.1202 232.64324 -11.61431 7.4878034 -1075.127 -1067.6392 - 24600 2.46 0.076457237 1266.9925 233.34522 -11.628582 7.510397 -1075.1496 -1067.6392 - 24650 2.465 0.076457198 1282.9995 232.39636 -11.648257 7.4798573 -1075.1191 -1067.6392 - 24700 2.47 0.07645726 1305.414 229.20359 -11.674265 7.3770956 -1075.0163 -1067.6392 - 24750 2.475 0.07645732 1301.6393 224.60137 -11.703977 7.2289695 -1074.8682 -1067.6392 - 24800 2.48 0.076457337 1286.6037 220.28411 -11.728511 7.090015 -1074.7292 -1067.6392 - 24850 2.485 0.076457248 1285.2636 217.75575 -11.741746 7.0086378 -1074.6479 -1067.6392 - 24900 2.49 0.076457211 1273.3347 217.15842 -11.738866 6.9894122 -1074.6286 -1067.6392 - 24950 2.495 0.076457314 1254.4627 217.67065 -11.724117 7.0058988 -1074.6451 -1067.6392 - 25000 2.5 0.07645736 1252.7349 218.6929 -11.717307 7.0388007 -1074.678 -1067.6392 - 25050 2.505 0.076457303 1253.3725 220.1096 -11.733758 7.0843985 -1074.7236 -1067.6392 - 25100 2.51 0.076457303 1226.6085 221.88399 -11.763112 7.1415083 -1074.7807 -1067.6392 - 25150 2.515 0.076457323 1179.7816 224.12648 -11.787319 7.2136847 -1074.8529 -1067.6392 - 25200 2.52 0.076457341 1147.9357 227.17475 -11.806595 7.3117955 -1074.951 -1067.6392 - 25250 2.525 0.076457289 1122.8538 230.61744 -11.827081 7.4226013 -1075.0618 -1067.6392 - 25300 2.53 0.076457275 1123.0584 232.62891 -11.840179 7.487342 -1075.1266 -1067.6392 - 25350 2.535 0.076457325 1135.7283 231.67931 -11.840266 7.4567784 -1075.096 -1067.6392 - 25400 2.54 0.076457369 1132.9884 228.34818 -11.841402 7.3495632 -1074.9888 -1067.6392 - 25450 2.545 0.076457373 1126.8396 224.33046 -11.849704 7.2202499 -1074.8595 -1067.6392 - 25500 2.55 0.076457345 1138.9754 220.94924 -11.854541 7.1114227 -1074.7507 -1067.6392 - 25550 2.555 0.076457293 1161.4091 218.97947 -11.85351 7.0480242 -1074.6873 -1067.6392 - 25600 2.56 0.076457314 1174.3492 218.77523 -11.860158 7.0414507 -1074.6807 -1067.6392 - 25650 2.565 0.07645744 1168.4635 220.04213 -11.881157 7.0822266 -1074.7215 -1067.6392 - 25700 2.57 0.076457455 1176.9925 222.26325 -11.910611 7.153715 -1074.7929 -1067.6392 - 25750 2.575 0.076457341 1184.7961 225.03857 -11.939316 7.2430409 -1074.8823 -1067.6392 - 25800 2.58 0.076457304 1154.7511 227.79451 -11.960291 7.3317431 -1074.971 -1067.6392 - 25850 2.585 0.076457382 1114.3611 229.90007 -11.97576 7.3995122 -1075.0387 -1067.6392 - 25900 2.59 0.076457443 1085.8869 230.83015 -11.989347 7.4294476 -1075.0687 -1067.6392 - 25950 2.595 0.076457402 1078.3201 230.19636 -12.002061 7.4090485 -1075.0483 -1067.6392 - 26000 2.6 0.076457319 1095.9541 227.61221 -12.008597 7.3258755 -1074.9651 -1067.6392 - 26050 2.605 0.076457291 1140.9903 223.50282 -12.008527 7.1936117 -1074.8328 -1067.6392 - 26100 2.61 0.076457385 1178.622 219.76032 -12.018995 7.0731563 -1074.7124 -1067.6392 - 26150 2.615 0.076457448 1173.4374 218.06955 -12.044671 7.0187377 -1074.658 -1067.6392 - 26200 2.62 0.076457408 1151.1453 218.96082 -12.075861 7.0474238 -1074.6867 -1067.6392 - 26250 2.625 0.076457383 1155.4138 222.06391 -12.101821 7.1472992 -1074.7865 -1067.6392 - 26300 2.63 0.076457372 1194.7964 226.66949 -12.116261 7.2955333 -1074.9348 -1067.6392 - 26350 2.635 0.076457363 1223.2766 232.21329 -12.127208 7.4739649 -1075.1132 -1067.6392 - 26400 2.64 0.076457354 1223.9805 237.61275 -12.140513 7.6477507 -1075.287 -1067.6392 - 26450 2.645 0.076457281 1218.086 241.25999 -12.14955 7.7651401 -1075.4044 -1067.6392 - 26500 2.65 0.07645724 1226.9905 242.22464 -12.151248 7.7961882 -1075.4354 -1067.6392 - 26550 2.655 0.076457293 1247.8203 240.6035 -12.151475 7.7440104 -1075.3832 -1067.6392 - 26600 2.66 0.076457269 1242.9798 237.04434 -12.161376 7.6294559 -1075.2687 -1067.6392 - 26650 2.665 0.076457162 1205.6877 232.19203 -12.183196 7.4732806 -1075.1125 -1067.6392 - 26700 2.67 0.07645716 1172.6996 227.25303 -12.214748 7.3143152 -1074.9535 -1067.6392 - 26750 2.675 0.076457262 1153.9255 224.05517 -12.256042 7.2113895 -1074.8506 -1067.6392 - 26800 2.68 0.076457311 1136.0414 223.48738 -12.295525 7.1931146 -1074.8323 -1067.6392 - 26850 2.685 0.076457307 1118.9445 225.12955 -12.319088 7.2459693 -1074.8852 -1067.6392 - 26900 2.69 0.076457308 1108.0624 228.2382 -12.325255 7.3460238 -1074.9853 -1067.6392 - 26950 2.695 0.076457378 1116.2269 232.45212 -12.323702 7.4816518 -1075.1209 -1067.6392 - 27000 2.7 0.07645739 1134.9488 237.58432 -12.328662 7.6468358 -1075.2861 -1067.6392 - 27050 2.705 0.07645735 1138.9878 242.69968 -12.344967 7.8114775 -1075.4507 -1067.6392 - 27100 2.71 0.07645736 1129.3313 246.18245 -12.366079 7.9235733 -1075.5628 -1067.6392 - 27150 2.715 0.076457354 1124.2775 246.92127 -12.384885 7.9473528 -1075.5866 -1067.6392 - 27200 2.72 0.076457305 1108.739 245.14655 -12.403913 7.8902318 -1075.5295 -1067.6392 - 27250 2.725 0.076457306 1108.6304 241.74994 -12.427874 7.7809096 -1075.4201 -1067.6392 - 27300 2.73 0.076457366 1145.8269 237.40384 -12.453673 7.641027 -1075.2803 -1067.6392 - 27350 2.735 0.076457346 1182.0337 232.72259 -12.475581 7.4903572 -1075.1296 -1067.6392 - 27400 2.74 0.076457288 1197.1644 228.48145 -12.490327 7.3538529 -1074.9931 -1067.6392 - 27450 2.745 0.076457272 1211.3793 225.74198 -12.50044 7.2656808 -1074.9049 -1067.6392 - 27500 2.75 0.076457331 1258.8799 225.52316 -12.511305 7.2586379 -1074.8979 -1067.6392 - 27550 2.755 0.076457388 1308.0524 227.54337 -12.522462 7.3236601 -1074.9629 -1067.6392 - 27600 2.76 0.076457348 1328.121 230.14115 -12.523762 7.4072716 -1075.0465 -1067.6392 - 27650 2.765 0.076457243 1340.2612 232.32442 -12.510293 7.4775417 -1075.1168 -1067.6392 - 27700 2.77 0.076457161 1351.5963 234.3197 -12.488706 7.5417616 -1075.181 -1067.6392 - 27750 2.775 0.076457282 1357.7982 236.12334 -12.460757 7.5998128 -1075.239 -1067.6392 - 27800 2.78 0.076457422 1361.4651 237.29306 -12.430447 7.6374614 -1075.2767 -1067.6392 - 27850 2.785 0.076457378 1361.9438 237.41071 -12.408369 7.6412479 -1075.2805 -1067.6392 - 27900 2.79 0.076457207 1354.0021 236.45794 -12.402868 7.6105824 -1075.2498 -1067.6392 - 27950 2.795 0.076457167 1330.2965 235.02473 -12.414971 7.5644534 -1075.2037 -1067.6392 - 28000 2.8 0.076457251 1299.3048 233.7726 -12.43317 7.5241524 -1075.1634 -1067.6392 - 28050 2.805 0.076457269 1277.0133 233.28243 -12.448406 7.5083761 -1075.1476 -1067.6392 - 28100 2.81 0.076457225 1251.8497 234.0353 -12.464212 7.5326077 -1075.1718 -1067.6392 - 28150 2.815 0.076457297 1208.4966 235.64084 -12.477803 7.5842833 -1075.2235 -1067.6392 - 28200 2.82 0.076457399 1198.6158 237.16084 -12.484054 7.6332057 -1075.2724 -1067.6392 - 28250 2.825 0.076457406 1239.4401 237.9696 -12.486107 7.6592361 -1075.2985 -1067.6392 - 28300 2.83 0.076457357 1293.9124 237.8743 -12.489779 7.6561691 -1075.2954 -1067.6392 - 28350 2.835 0.076457319 1312.3301 237.34832 -12.50409 7.63924 -1075.2785 -1067.6392 - 28400 2.84 0.076457322 1285.5505 237.14016 -12.527163 7.6325402 -1075.2718 -1067.6392 - 28450 2.845 0.076457378 1245.9557 237.75445 -12.548289 7.6523114 -1075.2915 -1067.6392 - 28500 2.85 0.076457388 1235.3861 238.91062 -12.557157 7.6895238 -1075.3288 -1067.6392 - 28550 2.855 0.076457337 1268.9513 240.25184 -12.560084 7.7326918 -1075.3719 -1067.6392 - 28600 2.86 0.076457363 1304.4221 241.87684 -12.576878 7.7849937 -1075.4242 -1067.6392 - 28650 2.865 0.076457362 1297.8936 243.05258 -12.60596 7.8228358 -1075.4621 -1067.6392 - 28700 2.87 0.076457347 1249.8912 242.36176 -12.630048 7.8006014 -1075.4398 -1067.6392 - 28750 2.875 0.076457391 1211.5737 239.53884 -12.648513 7.7097434 -1075.349 -1067.6392 - 28800 2.88 0.076457383 1202.6703 235.69511 -12.669768 7.58603 -1075.2253 -1067.6392 - 28850 2.885 0.07645729 1216.8735 232.20584 -12.686867 7.4737252 -1075.113 -1067.6392 - 28900 2.89 0.076457246 1241.5924 230.54911 -12.693862 7.4204019 -1075.0596 -1067.6392 - 28950 2.895 0.076457286 1240.767 231.97347 -12.701097 7.4662461 -1075.1055 -1067.6392 - 29000 2.9 0.076457358 1217.5962 236.18629 -12.716277 7.6018392 -1075.2411 -1067.6392 - 29050 2.905 0.076457432 1196.6203 241.17448 -12.73636 7.7623879 -1075.4016 -1067.6392 - 29100 2.91 0.076457522 1195.7297 244.6264 -12.752906 7.8734904 -1075.5127 -1067.6392 - 29150 2.915 0.076457557 1231.0931 245.54928 -12.765411 7.9031941 -1075.5424 -1067.6392 - 29200 2.92 0.07645753 1267.4904 244.15127 -12.781472 7.8581982 -1075.4974 -1067.6392 - 29250 2.925 0.076457521 1284.1755 240.9389 -12.800258 7.7548054 -1075.394 -1067.6392 - 29300 2.93 0.076457564 1286.0387 237.25035 -12.821281 7.6360866 -1075.2753 -1067.6392 - 29350 2.935 0.076457553 1256.2955 235.11519 -12.847909 7.5673647 -1075.2066 -1067.6392 - 29400 2.94 0.076457534 1204.4184 235.8746 -12.878902 7.591807 -1075.231 -1067.6392 - 29450 2.945 0.076457502 1156.6997 239.23804 -12.906804 7.700062 -1075.3393 -1067.6392 - 29500 2.95 0.076457485 1116.1408 243.69565 -12.924534 7.8435336 -1075.4828 -1067.6392 - 29550 2.955 0.076457504 1105.9977 247.90665 -12.938831 7.979068 -1075.6183 -1067.6392 - 29600 2.96 0.076457547 1114.6315 250.84823 -12.956708 8.0737448 -1075.713 -1067.6392 - 29650 2.965 0.07645753 1139.9431 251.55972 -12.974842 8.0966448 -1075.7359 -1067.6392 - 29700 2.97 0.076457492 1194.9224 249.83103 -12.990073 8.0410056 -1075.6802 -1067.6392 - 29750 2.975 0.076457443 1239.364 246.6967 -13.001472 7.9401246 -1075.5794 -1067.6392 - 29800 2.98 0.076457457 1252.6783 243.80542 -13.010513 7.8470666 -1075.4863 -1067.6392 - 29850 2.985 0.076457512 1240.1645 241.74022 -13.018373 7.7805965 -1075.4198 -1067.6392 - 29900 2.99 0.076457565 1223.7615 239.43409 -13.020593 7.7063721 -1075.3456 -1067.6392 - 29950 2.995 0.076457595 1204.1487 235.75951 -13.015055 7.5881027 -1075.2273 -1067.6392 - 30000 3 0.076457625 1186.3894 230.7717 -13.002308 7.4275663 -1075.0668 -1067.6392 - 30050 3.005 0.076457551 1196.5894 226.06185 -12.988551 7.275976 -1074.9152 -1067.6392 - 30100 3.01 0.076457433 1233.2652 224.05561 -12.98272 7.2114038 -1074.8506 -1067.6392 - 30150 3.015 0.076457506 1263.4065 226.5763 -12.989178 7.2925339 -1074.9318 -1067.6392 - 30200 3.02 0.076457597 1273.2272 233.82971 -13.003426 7.5259905 -1075.1652 -1067.6392 - 30250 3.025 0.076457526 1276.9473 244.40258 -13.018097 7.8662868 -1075.5055 -1067.6392 - 30300 3.03 0.076457432 1275.5446 255.93782 -13.034602 8.2375574 -1075.8768 -1067.6392 - 30350 3.035 0.076457464 1250.8783 265.87839 -13.057824 8.5575024 -1076.1967 -1067.6392 - 30400 3.04 0.076457427 1235.9551 272.00442 -13.083661 8.7546732 -1076.3939 -1067.6392 - 30450 3.045 0.076457316 1235.5042 273.37792 -13.111283 8.7988804 -1076.4381 -1067.6392 - 30500 3.05 0.07645726 1230.6233 270.64686 -13.146707 8.7109792 -1076.3502 -1067.6392 - 30550 3.055 0.076457233 1224.1115 265.0222 -13.182314 8.5299452 -1076.1692 -1067.6392 - 30600 3.06 0.076457361 1212.3027 257.68391 -13.202367 8.2937568 -1075.933 -1067.6392 - 30650 3.065 0.076457487 1190.0178 249.77024 -13.201564 8.0390489 -1075.6783 -1067.6392 - 30700 3.07 0.076457394 1161.8109 242.31657 -13.191293 7.7991468 -1075.4384 -1067.6392 - 30750 3.075 0.076457252 1158.6855 236.08427 -13.18911 7.5985553 -1075.2378 -1067.6392 - 30800 3.08 0.076457183 1168.5206 231.60347 -13.197075 7.4543374 -1075.0936 -1067.6392 - 30850 3.085 0.076457279 1158.9328 229.71585 -13.209643 7.3935831 -1075.0328 -1067.6392 - 30900 3.09 0.076457454 1136.1168 231.05928 -13.230895 7.4368221 -1075.0761 -1067.6392 - 30950 3.095 0.076457365 1140.4629 234.79871 -13.261019 7.5571786 -1075.1964 -1067.6392 - 31000 3.1 0.076457233 1151.4718 238.95885 -13.2835 7.691076 -1075.3303 -1067.6392 - 31050 3.105 0.076457249 1136.0165 241.99628 -13.285479 7.7888381 -1075.4281 -1067.6392 - 31100 3.11 0.076457312 1095.4919 243.6173 -13.274528 7.841012 -1075.4802 -1067.6392 - 31150 3.115 0.076457361 1043.3403 244.60685 -13.261288 7.8728613 -1075.5121 -1067.6392 - 31200 3.12 0.076457255 1000.1386 246.53553 -13.250369 7.9349374 -1075.5742 -1067.6392 - 31250 3.125 0.076457166 991.81643 250.55835 -13.24872 8.0644151 -1075.7036 -1067.6392 - 31300 3.13 0.076457166 1022.1079 256.4075 -13.267835 8.2526743 -1075.8919 -1067.6392 - 31350 3.135 0.076457189 1054.9092 262.76827 -13.305663 8.4574006 -1076.0966 -1067.6392 - 31400 3.14 0.07645724 1060.5815 267.85735 -13.342713 8.6211968 -1076.2604 -1067.6392 - 31450 3.145 0.076457287 1049.3579 269.97994 -13.36678 8.6895138 -1076.3287 -1067.6392 - 31500 3.15 0.076457292 1020.7582 268.2573 -13.386937 8.6340694 -1076.2733 -1067.6392 - 31550 3.155 0.076457309 996.86817 262.55532 -13.414409 8.4505467 -1076.0898 -1067.6392 - 31600 3.16 0.076457265 988.4472 253.14804 -13.44617 8.1477662 -1075.787 -1067.6392 - 31650 3.165 0.07645717 975.20678 241.3533 -13.472839 7.7681433 -1075.4074 -1067.6392 - 31700 3.17 0.076457122 978.08946 230.12225 -13.489241 7.4066632 -1075.0459 -1067.6392 - 31750 3.175 0.076457159 994.1906 223.24272 -13.4961 7.1852402 -1074.8245 -1067.6392 - 31800 3.18 0.076457198 1011.9808 223.61603 -13.502125 7.1972556 -1074.8365 -1067.6392 - 31850 3.185 0.076457197 1043.2929 231.32793 -13.514524 7.4454691 -1075.0847 -1067.6392 - 31900 3.19 0.076457211 1073.2125 243.48614 -13.529663 7.8367904 -1075.476 -1067.6392 - 31950 3.195 0.076457283 1089.512 255.96547 -13.531619 8.2384474 -1075.8777 -1067.6392 - 32000 3.2 0.076457346 1091.1766 265.64481 -13.515072 8.5499844 -1076.1892 -1067.6392 - 32050 3.205 0.076457238 1107.4466 271.60773 -13.502747 8.7419056 -1076.3811 -1067.6392 - 32100 3.21 0.076457153 1117.8805 274.08365 -13.50656 8.8215948 -1076.4608 -1067.6392 - 32150 3.215 0.076457122 1123.2092 273.86962 -13.522054 8.8147064 -1076.4539 -1067.6392 - 32200 3.22 0.076457105 1152.6197 271.95614 -13.543888 8.7531194 -1076.3924 -1067.6392 - 32250 3.225 0.076457164 1168.3769 268.86435 -13.563301 8.6536078 -1076.2928 -1067.6392 - 32300 3.23 0.076457237 1158.6589 265.10575 -13.580865 8.5326342 -1076.1719 -1067.6392 - 32350 3.235 0.076457159 1152.9881 261.29815 -13.605255 8.4100836 -1076.0493 -1067.6392 - 32400 3.24 0.07645703 1164.2634 257.27542 -13.625646 8.280609 -1075.9198 -1067.6392 - 32450 3.245 0.076457057 1173.0337 252.87376 -13.637472 8.1389381 -1075.7782 -1067.6392 - 32500 3.25 0.076457171 1170.4615 248.34575 -13.651248 7.9932007 -1075.6324 -1067.6392 - 32550 3.255 0.076457164 1172.6715 244.01198 -13.667945 7.8537149 -1075.4929 -1067.6392 - 32600 3.26 0.076457072 1178.0602 240.61161 -13.683594 7.7442715 -1075.3835 -1067.6392 - 32650 3.265 0.076457132 1164.2276 239.08635 -13.693266 7.6951799 -1075.3344 -1067.6392 - 32700 3.27 0.07645721 1135.6536 239.997 -13.697188 7.7244896 -1075.3637 -1067.6392 - 32750 3.275 0.07645717 1122.6725 242.77278 -13.697307 7.8138302 -1075.4531 -1067.6392 - 32800 3.28 0.076457087 1124.7984 246.08264 -13.698507 7.9203608 -1075.5596 -1067.6392 - 32850 3.285 0.076457071 1132.9874 248.8912 -13.71026 8.0107565 -1075.65 -1067.6392 - 32900 3.29 0.076457146 1144.7957 250.92712 -13.736297 8.0762841 -1075.7155 -1067.6392 - 32950 3.295 0.07645721 1152.7642 252.46291 -13.764351 8.1257148 -1075.7649 -1067.6392 - 33000 3.3 0.076457168 1146.2857 254.10358 -13.779597 8.1785209 -1075.8178 -1067.6392 - 33050 3.305 0.076457077 1145.5084 256.8303 -13.789612 8.2662826 -1075.9055 -1067.6392 - 33100 3.31 0.076457096 1154.4041 261.13865 -13.808552 8.40495 -1076.0442 -1067.6392 - 33150 3.315 0.07645715 1125.5641 266.3904 -13.833889 8.5739819 -1076.2132 -1067.6392 - 33200 3.32 0.07645715 1093.2946 271.0557 -13.855364 8.724138 -1076.3634 -1067.6392 - 33250 3.325 0.076457145 1095.5775 273.48025 -13.872191 8.8021741 -1076.4414 -1067.6392 - 33300 3.33 0.076457162 1100.9708 272.81497 -13.884719 8.7807615 -1076.42 -1067.6392 - 33350 3.335 0.07645717 1097.446 269.39464 -13.884534 8.6706755 -1076.3099 -1067.6392 - 33400 3.34 0.076457107 1081.3925 264.90836 -13.877973 8.5262812 -1076.1655 -1067.6392 - 33450 3.345 0.076457118 1078.1638 261.34438 -13.882973 8.4115716 -1076.0508 -1067.6392 - 33500 3.35 0.076457263 1098.4302 259.43885 -13.901235 8.3502409 -1075.9895 -1067.6392 - 33550 3.355 0.0764573 1113.653 258.79858 -13.925503 8.3296331 -1075.9689 -1067.6392 - 33600 3.36 0.076457139 1102.1918 258.64576 -13.952352 8.3247147 -1075.9639 -1067.6392 - 33650 3.365 0.076457044 1079.3943 258.32267 -13.984128 8.3143157 -1075.9535 -1067.6392 - 33700 3.37 0.076457092 1080.4816 257.3355 -14.022263 8.2825429 -1075.9218 -1067.6392 - 33750 3.375 0.076457159 1091.9482 255.16753 -14.058006 8.2127649 -1075.852 -1067.6392 - 33800 3.38 0.076457132 1093.3842 251.7622 -14.081909 8.1031619 -1075.7424 -1067.6392 - 33850 3.385 0.076457194 1089.6902 248.0965 -14.095869 7.9851785 -1075.6244 -1067.6392 - 33900 3.39 0.07645727 1096.6474 246.01593 -14.105391 7.9182138 -1075.5574 -1067.6392 - 33950 3.395 0.076457209 1126.664 247.11823 -14.104952 7.9536921 -1075.5929 -1067.6392 - 34000 3.4 0.076457164 1147.9196 251.93896 -14.093155 8.1088509 -1075.7481 -1067.6392 - 34050 3.405 0.076457179 1139.0305 259.69551 -14.085668 8.3585014 -1075.9977 -1067.6392 - 34100 3.41 0.076457311 1111.5824 268.28371 -14.096523 8.6349193 -1076.2742 -1067.6392 - 34150 3.415 0.076457318 1093.8889 274.76774 -14.115851 8.8436128 -1076.4828 -1067.6392 - 34200 3.42 0.076457165 1080.138 277.06119 -14.126901 8.9174293 -1076.5567 -1067.6392 - 34250 3.425 0.076457126 1068.8702 275.51584 -14.137497 8.867691 -1076.5069 -1067.6392 - 34300 3.43 0.076457173 1079.0654 272.17988 -14.166544 8.7603208 -1076.3996 -1067.6392 - 34350 3.435 0.076457237 1097.2929 268.53315 -14.204534 8.6429479 -1076.2822 -1067.6392 - 34400 3.44 0.076457306 1090.4064 265.24166 -14.230854 8.5370086 -1076.1762 -1067.6392 - 34450 3.445 0.076457334 1094.1532 263.10158 -14.24558 8.4681285 -1076.1074 -1067.6392 - 34500 3.45 0.076457326 1091.6462 262.74486 -14.260327 8.4566473 -1076.0959 -1067.6392 - 34550 3.455 0.076457285 1048.9417 263.68384 -14.279645 8.486869 -1076.1261 -1067.6392 - 34600 3.46 0.076457322 1035.8659 264.38837 -14.298673 8.509545 -1076.1488 -1067.6392 - 34650 3.465 0.076457348 1072.1468 263.89728 -14.317443 8.4937389 -1076.133 -1067.6392 - 34700 3.47 0.076457257 1099.9068 262.7456 -14.336515 8.4566712 -1076.0959 -1067.6392 - 34750 3.475 0.07645724 1086.8308 262.31079 -14.346872 8.4426763 -1076.0819 -1067.6392 - 34800 3.48 0.076457278 1063.2908 263.8317 -14.348034 8.491628 -1076.1309 -1067.6392 - 34850 3.485 0.076457253 1055.3547 267.54832 -14.355638 8.6112503 -1076.2505 -1067.6392 - 34900 3.49 0.076457295 1035.2728 272.01532 -14.373099 8.7550243 -1076.3943 -1067.6392 - 34950 3.495 0.076457375 1040.634 275.06802 -14.390413 8.8532777 -1076.4925 -1067.6392 - 35000 3.5 0.076457344 1063.0087 275.5042 -14.407745 8.8673167 -1076.5065 -1067.6392 - 35050 3.505 0.076457312 1058.6708 273.65876 -14.433515 8.8079196 -1076.4472 -1067.6392 - 35100 3.51 0.076457257 1060.8523 271.14098 -14.474773 8.7268829 -1076.3661 -1067.6392 - 35150 3.515 0.076457289 1067.0827 269.23085 -14.526301 8.6654039 -1076.3046 -1067.6392 - 35200 3.52 0.07645742 1062.2236 268.14335 -14.573177 8.6304019 -1076.2696 -1067.6392 - 35250 3.525 0.076457337 1070.5812 267.81607 -14.60424 8.6198681 -1076.2591 -1067.6392 - 35300 3.53 0.076457217 1072.5143 267.83883 -14.617097 8.6206007 -1076.2598 -1067.6392 - 35350 3.535 0.076457254 1028.3355 267.52283 -14.622569 8.6104298 -1076.2497 -1067.6392 - 35400 3.54 0.076457305 1002.1085 266.59937 -14.633762 8.5807077 -1076.2199 -1067.6392 - 35450 3.545 0.076457409 1029.413 265.25698 -14.649797 8.5375018 -1076.1767 -1067.6392 - 35500 3.55 0.076457478 1063.6674 263.65567 -14.671113 8.4859625 -1076.1252 -1067.6392 - 35550 3.555 0.076457385 1064.2389 261.55993 -14.712306 8.4185094 -1076.0577 -1067.6392 - 35600 3.56 0.076457248 1043.973 258.13746 -14.765767 8.3083544 -1075.9476 -1067.6392 - 35650 3.565 0.076457197 1018.5052 253.81996 -14.810087 8.1693925 -1075.8086 -1067.6392 - 35700 3.57 0.076457358 1000.6206 251.22894 -14.843694 8.0859983 -1075.7252 -1067.6392 - 35750 3.575 0.076457447 1017.4159 252.90054 -14.876657 8.1398 -1075.779 -1067.6392 - 35800 3.58 0.076457294 1047.8317 258.96411 -14.909538 8.3349608 -1075.9742 -1067.6392 - 35850 3.585 0.076457191 1082.9886 267.72357 -14.939208 8.6168909 -1076.2561 -1067.6392 - 35900 3.59 0.076457278 1100.5702 277.23543 -14.962644 8.9230375 -1076.5623 -1067.6392 - 35950 3.595 0.076457309 1086.933 285.96591 -14.977753 9.2040346 -1076.8433 -1067.6392 - 36000 3.6 0.076457255 1074.2647 292.9362 -14.987968 9.428379 -1077.0676 -1067.6392 - 36050 3.605 0.07645718 1055.2238 298.01121 -14.998446 9.5917221 -1077.231 -1067.6392 - 36100 3.61 0.076457233 1047.2166 302.00821 -15.020568 9.7203687 -1077.3596 -1067.6392 - 36150 3.615 0.076457349 1052.6407 305.28298 -15.059957 9.8257696 -1077.465 -1067.6392 - 36200 3.62 0.076457311 1060.7211 306.93482 -15.10603 9.8789354 -1077.5182 -1067.6392 - 36250 3.625 0.076457193 1068.8892 305.84803 -15.141949 9.8439561 -1077.4832 -1067.6392 - 36300 3.63 0.076457194 1061.6868 301.87989 -15.16629 9.7162384 -1077.3555 -1067.6392 - 36350 3.635 0.076457258 1057.9527 295.4431 -15.185933 9.5090656 -1077.1483 -1067.6392 - 36400 3.64 0.076457264 1064.3799 287.24818 -15.203507 9.2453055 -1076.8845 -1067.6392 - 36450 3.645 0.076457194 1063.7064 278.74515 -15.224498 8.9716288 -1076.6109 -1067.6392 - 36500 3.65 0.076457136 1061.3588 271.32268 -15.2455 8.732731 -1076.372 -1067.6392 - 36550 3.655 0.076457182 1067.1517 265.76761 -15.260325 8.5539369 -1076.1932 -1067.6392 - 36600 3.66 0.07645727 1089.9772 261.85411 -15.267562 8.4279778 -1076.0672 -1067.6392 - 36650 3.665 0.076457221 1104.789 258.4444 -15.265264 8.3182336 -1075.9575 -1067.6392 - 36700 3.67 0.07645716 1092.8435 255.00082 -15.25529 8.2073992 -1075.8466 -1067.6392 - 36750 3.675 0.076457168 1061.6595 252.8329 -15.247428 8.1376232 -1075.7769 -1067.6392 - 36800 3.68 0.076457215 1035.3281 254.03876 -15.243457 8.1764346 -1075.8157 -1067.6392 - 36850 3.685 0.076457264 1012.6747 259.66792 -15.232713 8.3576136 -1075.9968 -1067.6392 - 36900 3.69 0.07645721 1000.1165 269.04132 -15.219475 8.6593036 -1076.2985 -1067.6392 - 36950 3.695 0.076457158 1004.3738 279.5229 -15.222136 8.9966614 -1076.6359 -1067.6392 - 37000 3.7 0.076457194 1015.0789 287.52665 -15.242557 9.2542684 -1076.8935 -1067.6392 - 37050 3.705 0.076457209 1006.6001 291.33936 -15.269368 9.3769835 -1077.0162 -1067.6392 - 37100 3.71 0.076457215 1009.5254 292.25598 -15.292099 9.4064856 -1077.0457 -1067.6392 - 37150 3.715 0.076457221 1035.7983 292.7155 -15.306557 9.4212757 -1077.0605 -1067.6392 - 37200 3.72 0.076457114 1030.9374 293.77202 -15.308274 9.4552805 -1077.0945 -1067.6392 - 37250 3.725 0.076457028 982.50822 295.2423 -15.305932 9.5026027 -1077.1418 -1067.6392 - 37300 3.73 0.076457035 948.55083 296.17303 -15.311999 9.5325589 -1077.1718 -1067.6392 - 37350 3.735 0.076457098 937.47027 295.49824 -15.335364 9.5108401 -1077.1501 -1067.6392 - 37400 3.74 0.076457181 936.77662 292.98591 -15.385092 9.429979 -1077.0692 -1067.6392 - 37450 3.745 0.076457164 937.43311 288.88554 -15.44922 9.2980054 -1076.9372 -1067.6392 - 37500 3.75 0.076457095 942.75677 284.1287 -15.497475 9.1449027 -1076.7841 -1067.6392 - 37550 3.755 0.076457051 973.14442 280.71281 -15.516447 9.0349597 -1076.6742 -1067.6392 - 37600 3.76 0.076457064 1023.9535 280.23051 -15.517936 9.0194364 -1076.6587 -1067.6392 - 37650 3.765 0.076457028 1061.1038 282.66393 -15.519455 9.0977579 -1076.737 -1067.6392 - 37700 3.77 0.076457072 1070.7829 287.04664 -15.525411 9.2388189 -1076.8781 -1067.6392 - 37750 3.775 0.076457124 1066.3938 291.68394 -15.520525 9.388074 -1077.0273 -1067.6392 - 37800 3.78 0.076457071 1048.9796 294.14399 -15.497921 9.4672528 -1077.1065 -1067.6392 - 37850 3.785 0.076457038 1038.2533 292.47043 -15.480179 9.4133879 -1077.0526 -1067.6392 - 37900 3.79 0.076457018 1045.648 286.41439 -15.491193 9.2184695 -1076.8577 -1067.6392 - 37950 3.795 0.076457122 1065.9631 277.89366 -15.523881 8.9442232 -1076.5835 -1067.6392 - 38000 3.8 0.07645714 1090.5261 270.72264 -15.554861 8.7134183 -1076.3526 -1067.6392 - 38050 3.805 0.076457032 1113.2307 268.45698 -15.575531 8.6404964 -1076.2797 -1067.6392 - 38100 3.81 0.076457024 1116.2952 271.45106 -15.582548 8.7368631 -1076.3761 -1067.6392 - 38150 3.815 0.07645699 1093.8664 277.51108 -15.573712 8.9319094 -1076.5711 -1067.6392 - 38200 3.82 0.076456911 1051.845 284.62475 -15.56289 9.1608685 -1076.8001 -1067.6392 - 38250 3.825 0.076456883 1005.6732 291.31425 -15.566443 9.3761751 -1077.0154 -1067.6392 - 38300 3.83 0.076456909 998.58464 295.80008 -15.577737 9.5205551 -1077.1598 -1067.6392 - 38350 3.835 0.076456917 1023.8255 296.91935 -15.58617 9.5565797 -1077.1958 -1067.6392 - 38400 3.84 0.076457007 1038.0022 294.9054 -15.596528 9.4917592 -1077.131 -1067.6392 - 38450 3.845 0.076457031 1037.6121 290.96422 -15.616202 9.3649092 -1077.0041 -1067.6392 - 38500 3.85 0.076456984 1040.5904 286.88024 -15.646786 9.2334631 -1076.8727 -1067.6392 - 38550 3.855 0.076456918 1043.2321 284.56473 -15.689543 9.1589367 -1076.7982 -1067.6392 - 38600 3.86 0.076456877 1038.0862 284.74376 -15.739663 9.1646989 -1076.8039 -1067.6392 - 38650 3.865 0.076456988 1038.4376 285.95011 -15.776018 9.2035262 -1076.8428 -1067.6392 - 38700 3.87 0.076457066 1046.7517 286.45113 -15.793545 9.2196518 -1076.8589 -1067.6392 - 38750 3.875 0.076457085 1069.8363 286.1605 -15.809275 9.2102978 -1076.8495 -1067.6392 - 38800 3.88 0.076457103 1099.7649 286.35508 -15.838882 9.2165605 -1076.8558 -1067.6392 - 38850 3.885 0.076457029 1113.9425 288.09011 -15.885059 9.2724039 -1076.9116 -1067.6392 - 38900 3.89 0.076457017 1105.7043 290.97132 -15.928294 9.3651376 -1077.0044 -1067.6392 - 38950 3.895 0.076456995 1093.6515 294.07778 -15.945379 9.4651215 -1077.1044 -1067.6392 - 39000 3.9 0.07645694 1103.4477 297.5125 -15.943567 9.5756706 -1077.2149 -1067.6392 - 39050 3.905 0.076457006 1109.1277 301.82187 -15.951259 9.7143712 -1077.3536 -1067.6392 - 39100 3.91 0.076456969 1114.3237 306.51524 -15.985628 9.865431 -1077.5047 -1067.6392 - 39150 3.915 0.076456912 1114.4623 309.57518 -16.034747 9.9639174 -1077.6032 -1067.6392 - 39200 3.92 0.07645697 1087.5299 308.28093 -16.061177 9.9222609 -1077.5615 -1067.6392 - 39250 3.925 0.076457004 1085.9492 302.29555 -16.058242 9.7296168 -1077.3688 -1067.6392 - 39300 3.93 0.076456952 1107.8421 294.53188 -16.053056 9.4797371 -1077.119 -1067.6392 - 39350 3.935 0.076456973 1124.1513 288.15688 -16.067119 9.2745528 -1076.9138 -1067.6392 - 39400 3.94 0.076457054 1137.2475 283.95115 -16.101525 9.1391882 -1076.7784 -1067.6392 - 39450 3.945 0.07645698 1135.1662 281.54817 -16.141252 9.0618462 -1076.7011 -1067.6392 - 39500 3.95 0.076456838 1099.0721 281.13694 -16.174509 9.0486105 -1076.6878 -1067.6392 - 39550 3.955 0.076456882 1049.5257 282.67803 -16.205325 9.0982117 -1076.7374 -1067.6392 - 39600 3.96 0.076457011 1027.3757 284.94192 -16.234406 9.1710768 -1076.8103 -1067.6392 - 39650 3.965 0.076456971 1017.794 286.75472 -16.252188 9.2294233 -1076.8687 -1067.6392 - 39700 3.97 0.076456888 1007.7805 288.56666 -16.25612 9.2877419 -1076.927 -1067.6392 - 39750 3.975 0.076456865 1012.8541 292.07722 -16.261884 9.4007319 -1077.04 -1067.6392 - 39800 3.98 0.076456816 1043.1577 297.78139 -16.277698 9.584325 -1077.2236 -1067.6392 - 39850 3.985 0.076456836 1077.8248 304.26971 -16.297835 9.7931567 -1077.4324 -1067.6392 - 39900 3.99 0.07645687 1094.0855 309.71669 -16.325371 9.9684719 -1077.6077 -1067.6392 - 39950 3.995 0.076456883 1064.1015 312.41437 -16.358615 10.055299 -1077.6945 -1067.6392 - 40000 4 0.076456877 1022.9431 310.99163 -16.375546 10.009507 -1077.6487 -1067.6392 - 40050 4.005 0.076456756 1013.7056 306.64402 -16.373477 9.8695757 -1077.5088 -1067.6392 - 40100 4.01 0.076456759 1007.6913 303.35311 -16.376022 9.7636554 -1077.4029 -1067.6392 - 40150 4.015 0.076456864 1004.252 303.81576 -16.385329 9.7785462 -1077.4178 -1067.6392 - 40200 4.02 0.076456912 1013.1412 307.22942 -16.384285 9.8884172 -1077.5276 -1067.6392 - 40250 4.025 0.076456867 1030.3871 310.68562 -16.369477 9.9996578 -1077.6389 -1067.6392 - 40300 4.03 0.076456789 1034.7373 311.09098 -16.352628 10.012705 -1077.6519 -1067.6392 - 40350 4.035 0.076456729 1033.1387 307.52717 -16.345575 9.8980007 -1077.5372 -1067.6392 - 40400 4.04 0.07645669 1062.9045 301.64635 -16.348471 9.708722 -1077.348 -1067.6392 - 40450 4.045 0.076456729 1073.8352 295.54356 -16.354824 9.5122988 -1077.1515 -1067.6392 - 40500 4.05 0.076456875 1045.0985 290.52511 -16.36464 9.3507761 -1076.99 -1067.6392 - 40550 4.055 0.076456839 1027.9258 287.44019 -16.379541 9.2514857 -1076.8907 -1067.6392 - 40600 4.06 0.076456646 1031.5216 286.57721 -16.388491 9.22371 -1076.8629 -1067.6392 - 40650 4.065 0.076456606 1055.0251 287.81611 -16.386366 9.2635847 -1076.9028 -1067.6392 - 40700 4.07 0.076456834 1081.6077 290.98909 -16.384202 9.3657097 -1077.0049 -1067.6392 - 40750 4.075 0.076457031 1095.8624 295.35171 -16.381535 9.5061241 -1077.1454 -1067.6392 - 40800 4.08 0.076456927 1091.1884 299.74612 -16.369379 9.6475614 -1077.2868 -1067.6392 - 40850 4.085 0.076456677 1072.8108 303.12714 -16.353468 9.7563823 -1077.3956 -1067.6392 - 40900 4.09 0.076456612 1071.4265 304.47082 -16.345218 9.7996295 -1077.4389 -1067.6392 - 40950 4.095 0.076456759 1087.5691 303.62065 -16.343756 9.7722663 -1077.4115 -1067.6392 - 41000 4.1 0.07645689 1093.1572 302.41466 -16.342931 9.7334506 -1077.3727 -1067.6392 - 41050 4.105 0.076456787 1077.0283 303.03079 -16.350207 9.7532811 -1077.3925 -1067.6392 - 41100 4.11 0.0764566 1063.8174 304.59541 -16.3659 9.8036396 -1077.4429 -1067.6392 - 41150 4.115 0.076456666 1067.2044 305.05378 -16.383874 9.8183927 -1077.4576 -1067.6392 - 41200 4.12 0.076456794 1067.5418 304.12177 -16.408325 9.7883952 -1077.4276 -1067.6392 - 41250 4.125 0.076456816 1047.1076 301.87307 -16.437615 9.716019 -1077.3553 -1067.6392 - 41300 4.13 0.076456766 1000.8676 298.01778 -16.464716 9.5919337 -1077.2312 -1067.6392 - 41350 4.135 0.076456687 958.82868 293.49143 -16.485682 9.4462495 -1077.0855 -1067.6392 - 41400 4.14 0.076456739 951.84883 290.80384 -16.499012 9.3597472 -1076.999 -1067.6392 - 41450 4.145 0.076456812 963.65591 292.08601 -16.507392 9.4010149 -1077.0402 -1067.6392 - 41500 4.15 0.076456843 975.72148 297.16323 -16.520849 9.5644292 -1077.2037 -1067.6392 - 41550 4.155 0.076456845 984.53332 303.16542 -16.53794 9.7576142 -1077.3968 -1067.6392 - 41600 4.16 0.076456751 985.80319 307.28815 -16.557303 9.8903077 -1077.5295 -1067.6392 - 41650 4.165 0.076456683 1002.2286 308.88612 -16.587168 9.9417395 -1077.581 -1067.6392 - 41700 4.17 0.076456643 1030.6323 308.39988 -16.625508 9.9260895 -1077.5653 -1067.6392 - 41750 4.175 0.07645661 1034.2586 306.29955 -16.665355 9.8584887 -1077.4977 -1067.6392 - 41800 4.18 0.076456559 1020.0175 303.06426 -16.703335 9.7543583 -1077.3936 -1067.6392 - 41850 4.185 0.076456676 991.59829 299.14498 -16.725328 9.6282135 -1077.2674 -1067.6392 - 41900 4.19 0.076456761 967.85853 296.19757 -16.730689 9.5333487 -1077.1726 -1067.6392 - 41950 4.195 0.076456701 975.82892 296.71617 -16.740926 9.5500402 -1077.1893 -1067.6392 - 42000 4.2 0.076456713 1002.2491 300.92024 -16.770609 9.6853516 -1077.3246 -1067.6392 - 42050 4.205 0.076456664 1009.6687 305.97966 -16.813995 9.8481928 -1077.4874 -1067.6392 - 42100 4.21 0.076456626 1003.7314 309.08496 -16.851376 9.9481394 -1077.5874 -1067.6392 - 42150 4.215 0.076456675 1009.5258 310.0374 -16.864204 9.9787942 -1077.618 -1067.6392 - 42200 4.22 0.076456733 1016.8827 310.8272 -16.85494 10.004215 -1077.6434 -1067.6392 - 42250 4.225 0.076456828 1023.91 312.80966 -16.842511 10.068022 -1077.7073 -1067.6392 - 42300 4.23 0.076456807 1019.5709 315.15173 -16.836523 10.143403 -1077.7826 -1067.6392 - 42350 4.235 0.076456685 1017.6755 316.23931 -16.830978 10.178408 -1077.8176 -1067.6392 - 42400 4.24 0.076456572 1035.9763 314.95382 -16.817532 10.137033 -1077.7763 -1067.6392 - 42450 4.245 0.076456544 1057.572 310.93678 -16.799682 10.007741 -1077.647 -1067.6392 - 42500 4.25 0.076456618 1077.1806 305.03796 -16.792574 9.8178834 -1077.4571 -1067.6392 - 42550 4.255 0.076456744 1090.5444 299.3483 -16.809848 9.6347572 -1077.274 -1067.6392 - 42600 4.26 0.076456726 1096.922 295.41747 -16.837401 9.5082406 -1077.1475 -1067.6392 - 42650 4.265 0.076456617 1103.2531 293.46673 -16.859813 9.4454545 -1077.0847 -1067.6392 - 42700 4.27 0.076456587 1104.4238 293.26317 -16.892288 9.4389029 -1077.0781 -1067.6392 - 42750 4.275 0.076456665 1083.3823 294.65311 -16.933936 9.4836391 -1077.1229 -1067.6392 - 42800 4.28 0.076456664 1042.3438 298.70068 -16.959665 9.6139133 -1077.2531 -1067.6392 - 42850 4.285 0.076456687 1013.4416 306.95616 -16.966168 9.8796223 -1077.5189 -1067.6392 - 42900 4.29 0.076456725 1011.1467 318.14544 -16.97008 10.239758 -1077.879 -1067.6392 - 42950 4.295 0.076456665 1017.4449 328.03985 -16.982627 10.558217 -1078.1975 -1067.6392 - 43000 4.3 0.076456617 1019.3575 333.03871 -17.008768 10.719109 -1078.3583 -1067.6392 - 43050 4.305 0.076456693 999.2679 332.30906 -17.055549 10.695625 -1078.3349 -1067.6392 - 43100 4.31 0.076456762 967.7236 326.28709 -17.109853 10.501803 -1078.141 -1067.6392 - 43150 4.315 0.076456687 976.16726 316.29296 -17.144504 10.180134 -1077.8194 -1067.6392 - 43200 4.32 0.076456692 1009.9146 306.30886 -17.155114 9.8587883 -1077.498 -1067.6392 - 43250 4.325 0.076456822 1011.5832 301.46146 -17.160687 9.7027711 -1077.342 -1067.6392 - 43300 4.33 0.076456891 993.25245 303.09136 -17.173125 9.7552307 -1077.3945 -1067.6392 - 43350 4.335 0.076456691 978.1423 307.90834 -17.186565 9.910269 -1077.5495 -1067.6392 - 43400 4.34 0.07645663 966.7299 311.62095 -17.191657 10.029762 -1077.669 -1067.6392 - 43450 4.345 0.076456883 971.37208 311.68351 -17.189726 10.031776 -1077.671 -1067.6392 - 43500 4.35 0.076456994 978.85437 307.94316 -17.193481 9.9113896 -1077.5506 -1067.6392 - 43550 4.355 0.076456767 996.27549 302.13712 -17.211228 9.7245177 -1077.3637 -1067.6392 - 43600 4.36 0.076456685 1016.7792 297.0799 -17.235609 9.5617472 -1077.201 -1067.6392 - 43650 4.365 0.076456862 1020.5319 294.98379 -17.245695 9.4942822 -1077.1335 -1067.6392 - 43700 4.37 0.076456832 1016.3483 296.10415 -17.238216 9.530342 -1077.1696 -1067.6392 - 43750 4.375 0.076456643 1012.7306 299.25575 -17.241809 9.6317786 -1077.271 -1067.6392 - 43800 4.38 0.076456789 1005.3285 303.54214 -17.262691 9.7697394 -1077.409 -1067.6392 - 43850 4.385 0.076456982 1003.3326 310.06269 -17.281251 9.9796085 -1077.6188 -1067.6392 - 43900 4.39 0.076456965 987.54044 320.52249 -17.299417 10.316265 -1077.9555 -1067.6392 - 43950 4.395 0.076456761 963.2584 333.20523 -17.330466 10.724469 -1078.3637 -1067.6392 - 44000 4.4 0.076456706 963.73639 342.88698 -17.367857 11.036084 -1078.6753 -1067.6392 - 44050 4.405 0.076456821 986.80537 345.16932 -17.395458 11.109542 -1078.7488 -1067.6392 - 44100 4.41 0.076456831 1009.8445 339.67355 -17.41311 10.932657 -1078.5719 -1067.6392 - 44150 4.415 0.076456785 1014.6601 330.05625 -17.436389 10.623116 -1078.2623 -1067.6392 - 44200 4.42 0.076456797 984.52199 321.8216 -17.48274 10.358078 -1077.9973 -1067.6392 - 44250 4.425 0.076456753 957.80787 317.33913 -17.54731 10.213806 -1077.853 -1067.6392 - 44300 4.43 0.076456643 940.00066 314.53772 -17.596853 10.123641 -1077.7629 -1067.6392 - 44350 4.435 0.076456628 918.4875 312.37225 -17.612235 10.053943 -1077.6932 -1067.6392 - 44400 4.44 0.07645672 913.57846 310.8786 -17.595301 10.005869 -1077.6451 -1067.6392 - 44450 4.445 0.076456761 919.4865 309.82858 -17.561225 9.9720734 -1077.6113 -1067.6392 - 44500 4.45 0.07645674 926.5393 309.78037 -17.534259 9.9705218 -1077.6097 -1067.6392 - 44550 4.455 0.076456708 929.10063 311.77335 -17.538056 10.034667 -1077.6739 -1067.6392 - 44600 4.46 0.076456694 933.10594 315.21765 -17.566473 10.145525 -1077.7848 -1067.6392 - 44650 4.465 0.076456702 926.71966 318.06782 -17.591174 10.23726 -1077.8765 -1067.6392 - 44700 4.47 0.076456707 911.59951 319.12218 -17.602472 10.271195 -1077.9104 -1067.6392 - 44750 4.475 0.076456688 910.70606 318.9204 -17.609049 10.264701 -1077.9039 -1067.6392 - 44800 4.48 0.0764567 905.05917 318.54255 -17.616129 10.252539 -1077.8918 -1067.6392 - 44850 4.485 0.076456621 894.49408 318.42782 -17.623448 10.248847 -1077.8881 -1067.6392 - 44900 4.49 0.076456517 906.7452 318.55777 -17.630547 10.253029 -1077.8923 -1067.6392 - 44950 4.495 0.076456564 912.1438 318.94548 -17.639597 10.265508 -1077.9047 -1067.6392 - 45000 4.5 0.076456621 904.16689 319.6676 -17.650569 10.28875 -1077.928 -1067.6392 - 45050 4.505 0.076456591 906.29138 321.41748 -17.664978 10.345071 -1077.9843 -1067.6392 - 45100 4.51 0.076456544 905.96789 325.06187 -17.678666 10.462369 -1078.1016 -1067.6392 - 45150 4.515 0.076456576 898.50939 330.26103 -17.687185 10.629708 -1078.2689 -1067.6392 - 45200 4.52 0.076456663 905.35412 334.94433 -17.701241 10.780443 -1078.4197 -1067.6392 - 45250 4.525 0.07645673 930.80225 336.07069 -17.72859 10.816696 -1078.4559 -1067.6392 - 45300 4.53 0.076456595 959.3922 331.6008 -17.765016 10.672829 -1078.3121 -1067.6392 - 45350 4.535 0.076456568 984.36318 321.62814 -17.802524 10.351851 -1077.9911 -1067.6392 - 45400 4.54 0.07645668 990.20053 308.8639 -17.836056 9.9410245 -1077.5803 -1067.6392 - 45450 4.545 0.076456648 947.25396 298.78614 -17.865782 9.6166638 -1077.2559 -1067.6392 - 45500 4.55 0.076456577 910.56022 297.55292 -17.905424 9.5769716 -1077.2162 -1067.6392 - 45550 4.555 0.076456563 888.63811 306.74089 -17.960609 9.8726936 -1077.5119 -1067.6392 - 45600 4.56 0.076456599 859.98987 321.07118 -18.005145 10.333925 -1077.9732 -1067.6392 - 45650 4.565 0.076456612 856.19145 333.40125 -18.019594 10.730778 -1078.37 -1067.6392 - 45700 4.57 0.076456557 878.62104 340.06144 -18.020894 10.945141 -1078.5844 -1067.6392 - 45750 4.575 0.076456566 897.45139 340.97037 -18.029395 10.974396 -1078.6136 -1067.6392 - 45800 4.58 0.076456592 900.06632 337.73275 -18.042178 10.870191 -1078.5094 -1067.6392 - 45850 4.585 0.076456653 905.65224 333.13083 -18.060834 10.722074 -1078.3613 -1067.6392 - 45900 4.59 0.076456731 911.50958 329.86483 -18.10231 10.616955 -1078.2562 -1067.6392 - 45950 4.595 0.076456674 934.98117 327.78934 -18.158233 10.550154 -1078.1894 -1067.6392 - 46000 4.6 0.076456573 960.91441 324.26975 -18.195778 10.436874 -1078.0761 -1067.6392 - 46050 4.605 0.076456596 962.59058 317.8452 -18.203481 10.230095 -1077.8693 -1067.6392 - 46100 4.61 0.076456671 960.19967 310.62901 -18.213042 9.9978359 -1077.6371 -1067.6392 - 46150 4.615 0.076456686 958.71855 305.95972 -18.235837 9.8475511 -1077.4868 -1067.6392 - 46200 4.62 0.076456612 966.32277 305.9278 -18.25351 9.8465235 -1077.4858 -1067.6392 - 46250 4.625 0.076456484 976.33095 310.79103 -18.261143 10.00305 -1077.6423 -1067.6392 - 46300 4.63 0.076456455 971.1525 319.21516 -18.262509 10.274188 -1077.9134 -1067.6392 - 46350 4.635 0.076456555 942.98388 329.128 -18.258965 10.59324 -1078.2325 -1067.6392 - 46400 4.64 0.07645659 931.95574 338.94782 -18.258301 10.909299 -1078.5485 -1067.6392 - 46450 4.645 0.076456634 952.04764 347.69672 -18.270432 11.190889 -1078.8301 -1067.6392 - 46500 4.65 0.076456695 954.27972 354.28335 -18.291901 11.402884 -1079.0421 -1067.6392 - 46550 4.655 0.076456718 932.47699 357.80024 -18.314064 11.516078 -1079.1553 -1067.6392 - 46600 4.66 0.076456571 917.15783 358.255 -18.33944 11.530715 -1079.1699 -1067.6392 - 46650 4.665 0.076456487 914.53778 356.10608 -18.373204 11.46155 -1079.1008 -1067.6392 - 46700 4.67 0.07645664 926.29271 351.32545 -18.410415 11.307682 -1078.9469 -1067.6392 - 46750 4.675 0.076456722 955.90982 343.62423 -18.443075 11.059813 -1078.699 -1067.6392 - 46800 4.68 0.076456662 968.52074 333.76849 -18.472665 10.742598 -1078.3818 -1067.6392 - 46850 4.685 0.076456611 960.55547 323.74847 -18.502955 10.420096 -1078.0593 -1067.6392 - 46900 4.69 0.07645658 969.48482 315.29249 -18.530555 10.147933 -1077.7872 -1067.6392 - 46950 4.695 0.076456538 970.41435 309.50703 -18.552649 9.9617239 -1077.601 -1067.6392 - 47000 4.7 0.076456607 973.5826 307.27705 -18.562429 9.8899503 -1077.5292 -1067.6392 - 47050 4.705 0.076456741 971.31274 309.44374 -18.561975 9.9596868 -1077.5989 -1067.6392 - 47100 4.71 0.076456567 974.56171 315.87966 -18.571858 10.166832 -1077.8061 -1067.6392 - 47150 4.715 0.076456487 989.886 324.3948 -18.59552 10.440899 -1078.0801 -1067.6392 - 47200 4.72 0.076456752 991.34022 333.02825 -18.624859 10.718773 -1078.358 -1067.6392 - 47250 4.725 0.076456811 982.33055 341.27988 -18.652892 10.984358 -1078.6236 -1067.6392 - 47300 4.73 0.076456654 969.07699 348.54206 -18.671538 11.218097 -1078.8573 -1067.6392 - 47350 4.735 0.076456603 950.49208 353.80509 -18.681778 11.387491 -1079.0267 -1067.6392 - 47400 4.74 0.076456655 932.53448 356.59027 -18.691148 11.477134 -1079.1164 -1067.6392 - 47450 4.745 0.07645674 914.98082 356.88075 -18.707177 11.486484 -1079.1257 -1067.6392 - 47500 4.75 0.076456846 910.29391 354.25323 -18.733572 11.401915 -1079.0411 -1067.6392 - 47550 4.755 0.076456842 911.79249 348.56319 -18.768858 11.218777 -1078.858 -1067.6392 - 47600 4.76 0.076456764 896.25715 341.13087 -18.817172 10.979562 -1078.6188 -1067.6392 - 47650 4.765 0.076456752 893.56376 333.65355 -18.869281 10.738898 -1078.3781 -1067.6392 - 47700 4.77 0.076456851 923.22366 328.05385 -18.908457 10.558668 -1078.1979 -1067.6392 - 47750 4.775 0.076456872 942.84866 326.28411 -18.929889 10.501707 -1078.1409 -1067.6392 - 47800 4.78 0.076456844 930.32583 328.44034 -18.932985 10.571107 -1078.2103 -1067.6392 - 47850 4.785 0.076456902 912.36756 332.89004 -18.922464 10.714324 -1078.3536 -1067.6392 - 47900 4.79 0.076456964 916.62133 338.11673 -18.919206 10.882549 -1078.5218 -1067.6392 - 47950 4.795 0.076457014 930.75246 342.30195 -18.922007 11.017254 -1078.6565 -1067.6392 - 48000 4.8 0.076457014 936.01421 343.78811 -18.908628 11.065087 -1078.7043 -1067.6392 - 48050 4.805 0.076456953 944.54584 342.44511 -18.878537 11.021862 -1078.6611 -1067.6392 - 48100 4.81 0.076456972 941.98405 339.08691 -18.851545 10.913775 -1078.553 -1067.6392 - 48150 4.815 0.076456898 920.11331 334.61456 -18.839033 10.769829 -1078.4091 -1067.6392 - 48200 4.82 0.076456871 907.83719 330.10701 -18.832157 10.62475 -1078.264 -1067.6392 - 48250 4.825 0.076456918 912.20647 327.58291 -18.826744 10.54351 -1078.1827 -1067.6392 - 48300 4.83 0.07645699 932.39917 329.24117 -18.830768 10.596882 -1078.2361 -1067.6392 - 48350 4.835 0.07645701 945.1163 335.0398 -18.840255 10.783516 -1078.4227 -1067.6392 - 48400 4.84 0.076456836 950.22061 342.35702 -18.841461 11.019026 -1078.6583 -1067.6392 - 48450 4.845 0.0764567 952.16965 348.50659 -18.834984 11.216955 -1078.8562 -1067.6392 - 48500 4.85 0.076456712 955.36854 352.21576 -18.825983 11.336338 -1078.9756 -1067.6392 - 48550 4.855 0.076456801 959.48836 353.76389 -18.820533 11.386165 -1079.0254 -1067.6392 - 48600 4.86 0.076456823 964.22846 354.04554 -18.822337 11.395231 -1079.0345 -1067.6392 - 48650 4.865 0.076456815 974.22885 352.93972 -18.818132 11.359639 -1078.9989 -1067.6392 - 48700 4.87 0.076456877 987.44079 349.70581 -18.807017 11.255553 -1078.8948 -1067.6392 - 48750 4.875 0.076456856 980.80712 344.37973 -18.808379 11.084129 -1078.7234 -1067.6392 - 48800 4.88 0.076456847 965.79638 337.63651 -18.81979 10.867093 -1078.5063 -1067.6392 - 48850 4.885 0.076457001 966.05115 330.7499 -18.830692 10.645442 -1078.2847 -1067.6392 - 48900 4.89 0.076457069 965.02834 325.77373 -18.849924 10.48528 -1078.1245 -1067.6392 - 48950 4.895 0.076456805 951.50135 324.61657 -18.890071 10.448036 -1078.0873 -1067.6392 - 49000 4.9 0.076456678 947.91103 327.27966 -18.934537 10.53375 -1078.173 -1067.6392 - 49050 4.905 0.076456661 958.11234 332.39046 -18.962498 10.698245 -1078.3375 -1067.6392 - 49100 4.91 0.076456829 970.05161 338.47836 -18.976168 10.894189 -1078.5334 -1067.6392 - 49150 4.915 0.07645699 968.15446 343.93729 -18.98603 11.069889 -1078.7091 -1067.6392 - 49200 4.92 0.076456985 960.59968 346.43043 -18.994109 11.150132 -1078.7894 -1067.6392 - 49250 4.925 0.076456928 945.53084 343.0733 -18.986613 11.042081 -1078.6813 -1067.6392 - 49300 4.93 0.076456888 920.51419 333.13647 -18.959986 10.722256 -1078.3615 -1067.6392 - 49350 4.935 0.076456851 907.35436 320.38291 -18.938752 10.311773 -1077.951 -1067.6392 - 49400 4.94 0.07645685 893.81547 310.99739 -18.938412 10.009692 -1077.6489 -1067.6392 - 49450 4.945 0.076456896 870.23823 309.67527 -18.95594 9.9671388 -1077.6064 -1067.6392 - 49500 4.95 0.076456955 872.77052 317.13999 -18.978605 10.207397 -1077.8466 -1067.6392 - 49550 4.955 0.076456967 894.83445 330.73629 -18.98876 10.645004 -1078.2842 -1067.6392 - 49600 4.96 0.076456979 912.1661 346.73247 -18.984428 11.159854 -1078.7991 -1067.6392 - 49650 4.965 0.076456993 915.70238 361.26297 -18.978545 11.627529 -1079.2668 -1067.6392 - 49700 4.97 0.076456983 924.58803 370.71298 -18.984487 11.931685 -1079.5709 -1067.6392 - 49750 4.975 0.076456922 944.17323 372.65166 -18.998747 11.994083 -1079.6333 -1067.6392 - 49800 4.98 0.076456923 948.92864 367.69228 -19.0113 11.834461 -1079.4737 -1067.6392 - 49850 4.985 0.076456921 953.93531 359.51215 -19.018592 11.571177 -1079.2104 -1067.6392 - 49900 4.99 0.076456974 963.60708 351.14054 -19.013112 11.301731 -1078.941 -1067.6392 - 49950 4.995 0.076456997 970.081 343.67798 -19.003119 11.061543 -1078.7008 -1067.6392 - 50000 5 0.076457012 1001.2522 337.57276 -19.005327 10.865041 -1078.5043 -1067.6392 -Loop time of 149.65 on 1 procs for 50000 steps with 250 atoms - -Performance: 2.887 ns/day, 8.314 hours/ns, 334.113 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 | 56.939 | 56.939 | 56.939 | 0.0 | 38.05 -Neigh | 0.65017 | 0.65017 | 0.65017 | 0.0 | 0.43 -Comm | 1.4958 | 1.4958 | 1.4958 | 0.0 | 1.00 -Output | 37.503 | 37.503 | 37.503 | 0.0 | 25.06 -Modify | 52.788 | 52.788 | 52.788 | 0.0 | 35.27 -Other | | 0.2742 | | | 0.18 - -Nlocal: 250 ave 250 max 250 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1335 ave 1335 max 1335 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 7746 ave 7746 max 7746 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 15492 ave 15492 max 15492 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 15492 -Ave neighs/atom = 61.968 -Neighbor list builds = 608 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:02:29 diff --git a/examples/SPIN/iron/log.30Apr19.spin.iron.g++.4 b/examples/SPIN/iron/log.30Apr19.spin.iron.g++.4 deleted file mode 100644 index 6fc3e307f0..0000000000 --- a/examples/SPIN/iron/log.30Apr19.spin.iron.g++.4 +++ /dev/null @@ -1,1117 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# bcc iron in a 3d periodic box - -clear - using 1 OpenMP thread(s) per MPI task -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice bcc 2.8665 -Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 250 atoms - create_atoms CPU = 0.00056982 secs - -# setting mass, mag. moments, and interactions for bcc iron - -mass 1 55.845 - -set group all spin/random 31 2.2 - 250 settings made for spin/random -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 3.5 -pair_coeff * * eam/alloy Fe_Mishin2006.eam.alloy Fe -pair_coeff * * spin/exchange exchange 3.4 0.02726 0.2171 1.841 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_tmag temp v_emag ke pe etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump_iron.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] - -run 50000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 5.77337 - ghost atom cutoff = 5.77337 - binsize = 2.88668, bins = 5 5 5 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.265 | 7.265 | 7.265 Mbytes -Step Time v_magnorm v_tmag Temp v_emag KinEng PotEng TotEng - 0 0 0.076456975 9109.0924 100.00358 -0.85791269 3.2186929 -1070.8579 -1067.6392 - 50 0.005 0.076456995 9402.4007 96.298333 -0.85659448 3.0994366 -1070.7387 -1067.6392 - 100 0.01 0.076457028 9589.1846 86.330828 -0.87003341 2.7786247 -1070.4179 -1067.6392 - 150 0.015 0.076457074 9673.9268 71.603402 -0.89006992 2.3046111 -1069.9438 -1067.6392 - 200 0.02 0.076457106 9509.1148 54.648817 -0.91124541 1.7589146 -1069.3981 -1067.6392 - 250 0.025 0.076457128 9004.27 38.599515 -0.93187522 1.2423553 -1068.8816 -1067.6392 - 300 0.03 0.076457157 8353.4371 26.383018 -0.95082226 0.8491579 -1068.4884 -1067.6392 - 350 0.035 0.076457207 7911.1316 20.01039 -0.96826468 0.64404992 -1068.2833 -1067.6392 - 400 0.04 0.076457243 7775.9492 20.097682 -0.98706373 0.64685949 -1068.2861 -1067.6392 - 450 0.045 0.076457231 7737.1225 25.687511 -1.0095684 0.82677249 -1068.466 -1067.6392 - 500 0.05 0.076457204 7676.9809 34.604697 -1.0349855 1.113779 -1068.753 -1067.6392 - 550 0.055 0.076457196 7550.2809 44.251809 -1.0609123 1.4242788 -1069.0635 -1067.6392 - 600 0.06 0.076457188 7209.7657 52.475202 -1.0880854 1.6889551 -1069.3282 -1067.6392 - 650 0.065 0.07645718 6691.1787 57.926479 -1.1179657 1.8644087 -1069.5036 -1067.6392 - 700 0.07 0.076457185 6276.4003 60.030548 -1.1469999 1.9321298 -1069.5714 -1067.6392 - 750 0.075 0.07645719 6149.9253 59.122504 -1.1721939 1.9029037 -1069.5421 -1067.6392 - 800 0.08 0.076457195 6207.0587 56.349146 -1.1949365 1.813641 -1069.4529 -1067.6392 - 850 0.085 0.076457199 6328.4635 53.154464 -1.2164642 1.7108177 -1069.35 -1067.6392 - 900 0.09 0.076457199 6456.2716 50.837416 -1.2366018 1.6362417 -1069.2755 -1067.6392 - 950 0.095 0.076457222 6495.1064 50.234549 -1.2539657 1.6168379 -1069.2561 -1067.6392 - 1000 0.1 0.076457266 6416.775 51.592727 -1.2671834 1.6605519 -1069.2998 -1067.6392 - 1050 0.105 0.076457256 6305.9015 54.719414 -1.2794824 1.7611868 -1069.4004 -1067.6392 - 1100 0.11 0.076457222 6165.987 59.01343 -1.2960617 1.8993931 -1069.5386 -1067.6392 - 1150 0.115 0.076457194 5941.7807 63.475298 -1.317859 2.0430017 -1069.6822 -1067.6392 - 1200 0.12 0.076457182 5692.0982 67.036713 -1.3432854 2.1576286 -1069.7969 -1067.6392 - 1250 0.125 0.076457217 5543.1736 68.917405 -1.3719994 2.2181602 -1069.8574 -1067.6392 - 1300 0.13 0.076457263 5507.9968 68.753418 -1.4042339 2.2128821 -1069.8521 -1067.6392 - 1350 0.135 0.076457286 5500.7848 66.608286 -1.4385667 2.1438394 -1069.7831 -1067.6392 - 1400 0.14 0.076457254 5523.456 62.967429 -1.4712143 2.0266556 -1069.6659 -1067.6392 - 1450 0.145 0.076457188 5501.5777 58.75732 -1.4990458 1.89115 -1069.5304 -1067.6392 - 1500 0.15 0.076457175 5324.4931 55.246308 -1.5236774 1.7781453 -1069.4174 -1067.6392 - 1550 0.155 0.076457234 5025.5908 53.607297 -1.5492947 1.7253925 -1069.3646 -1067.6392 - 1600 0.16 0.076457297 4742.9546 54.443418 -1.5785798 1.7523036 -1069.3915 -1067.6392 - 1650 0.165 0.076457321 4558.083 57.572305 -1.6113848 1.8530093 -1069.4922 -1067.6392 - 1700 0.17 0.076457304 4479.4352 62.073307 -1.6443595 1.9978776 -1069.6371 -1067.6392 - 1750 0.175 0.076457272 4520.5577 66.677964 -1.6742729 2.146082 -1069.7853 -1067.6392 - 1800 0.18 0.076457253 4659.9114 70.277293 -1.7021557 2.2619292 -1069.9012 -1067.6392 - 1850 0.185 0.076457257 4734.1597 72.135028 -1.7307798 2.3217219 -1069.961 -1067.6392 - 1900 0.19 0.076457279 4632.2637 71.873382 -1.7598165 2.3133006 -1069.9525 -1067.6392 - 1950 0.195 0.076457276 4496.6621 69.52131 -1.7866398 2.2375973 -1069.8768 -1067.6392 - 2000 0.2 0.076457276 4507.4594 65.61098 -1.8106776 2.1117403 -1069.751 -1067.6392 - 2050 0.205 0.076457288 4652.9279 61.016261 -1.8317479 1.9638557 -1069.6031 -1067.6392 - 2100 0.21 0.076457307 4738.4188 56.745795 -1.8489776 1.8264074 -1069.4656 -1067.6392 - 2150 0.215 0.076457279 4643.423 53.837376 -1.8647516 1.7327977 -1069.372 -1067.6392 - 2200 0.22 0.076457215 4517.9871 53.044053 -1.8828305 1.707264 -1069.3465 -1067.6392 - 2250 0.225 0.07645717 4436.4399 54.521839 -1.9038753 1.7548277 -1069.3941 -1067.6392 - 2300 0.23 0.076457132 4318.8261 57.895634 -1.9276454 1.8634159 -1069.5026 -1067.6392 - 2350 0.235 0.076457114 4148.8616 62.484473 -1.9559372 2.0111113 -1069.6503 -1067.6392 - 2400 0.24 0.076457144 4014.8498 67.404243 -1.9902034 2.1694579 -1069.8087 -1067.6392 - 2450 0.245 0.076457189 4004.017 71.654167 -2.0278558 2.306245 -1069.9455 -1067.6392 - 2500 0.25 0.076457202 4109.5497 74.379393 -2.0629968 2.3939585 -1070.0332 -1067.6392 - 2550 0.255 0.076457205 4251.6933 75.255112 -2.0918484 2.4221442 -1070.0614 -1067.6392 - 2600 0.26 0.076457208 4320.6876 74.700611 -2.1169691 2.4042972 -1070.0435 -1067.6392 - 2650 0.265 0.076457197 4297.5527 73.627823 -2.143 2.3697686 -1070.009 -1067.6392 - 2700 0.27 0.076457213 4198.4852 72.957211 -2.1702374 2.3481845 -1069.9874 -1067.6392 - 2750 0.275 0.076457256 4019.2384 73.353574 -2.1967187 2.3609417 -1070.0002 -1067.6392 - 2800 0.28 0.076457288 3867.2492 75.083781 -2.2227117 2.4166298 -1070.0559 -1067.6392 - 2850 0.285 0.076457302 3879.8471 77.82546 -2.2488766 2.5048728 -1070.1441 -1067.6392 - 2900 0.29 0.076457321 4003.8986 80.741745 -2.2742584 2.5987357 -1070.238 -1067.6392 - 2950 0.295 0.076457347 4026.6754 82.934399 -2.3001834 2.669308 -1070.3085 -1067.6392 - 3000 0.3 0.076457334 3857.2183 83.701738 -2.3291113 2.6940054 -1070.3332 -1067.6392 - 3050 0.305 0.076457295 3640.7581 82.615991 -2.3614721 2.6590598 -1070.2983 -1067.6392 - 3100 0.31 0.07645725 3489.102 79.573679 -2.3943974 2.5611406 -1070.2004 -1067.6392 - 3150 0.315 0.076457232 3396.4301 74.896125 -2.4236621 2.4105899 -1070.0498 -1067.6392 - 3200 0.32 0.076457259 3378.11 69.450128 -2.4483292 2.2353063 -1069.8745 -1067.6392 - 3250 0.325 0.076457289 3463.7734 64.542714 -2.4729224 2.0773573 -1069.7166 -1067.6392 - 3300 0.33 0.076457318 3637.4971 61.346221 -2.500303 1.9744757 -1069.6137 -1067.6392 - 3350 0.335 0.076457361 3833.5389 60.346704 -2.5252732 1.9423055 -1069.5815 -1067.6392 - 3400 0.34 0.076457387 3965.2081 61.464125 -2.5426842 1.9782706 -1069.6175 -1067.6392 - 3450 0.345 0.076457375 3976.7956 64.41797 -2.5565409 2.0733424 -1069.7126 -1067.6392 - 3500 0.35 0.076457371 3862.8334 68.714547 -2.5743062 2.211631 -1069.8509 -1067.6392 - 3550 0.355 0.076457375 3697.284 73.534942 -2.5974674 2.3667792 -1070.006 -1067.6392 - 3600 0.36 0.076457362 3575.9012 77.902682 -2.6209385 2.5073583 -1070.1466 -1067.6392 - 3650 0.365 0.076457345 3550.0667 81.043684 -2.6394846 2.6084539 -1070.2477 -1067.6392 - 3700 0.37 0.076457309 3535.0981 82.730976 -2.65464 2.6627607 -1070.302 -1067.6392 - 3750 0.375 0.076457309 3444.1795 83.322515 -2.6736085 2.6817998 -1070.321 -1067.6392 - 3800 0.38 0.076457348 3323.7191 83.436143 -2.7008525 2.685457 -1070.3247 -1067.6392 - 3850 0.385 0.076457368 3252.5404 83.62535 -2.7353937 2.6915468 -1070.3308 -1067.6392 - 3900 0.39 0.076457344 3219.5349 84.088597 -2.7722909 2.7064568 -1070.3457 -1067.6392 - 3950 0.395 0.076457316 3210.4164 84.636475 -2.8060651 2.7240906 -1070.3633 -1067.6392 - 4000 0.4 0.076457319 3223.9708 85.042888 -2.8352998 2.7371713 -1070.3764 -1067.6392 - 4050 0.405 0.076457335 3232.7108 85.266853 -2.8607963 2.7443798 -1070.3836 -1067.6392 - 4100 0.41 0.076457314 3206.1428 85.444074 -2.8837721 2.7500838 -1070.3893 -1067.6392 - 4150 0.415 0.076457325 3146.4589 85.771643 -2.9074131 2.7606269 -1070.3999 -1067.6392 - 4200 0.42 0.076457395 3092.6283 86.24875 -2.9341331 2.775983 -1070.4152 -1067.6392 - 4250 0.425 0.07645742 3103.0319 86.563557 -2.9622203 2.7861153 -1070.4253 -1067.6392 - 4300 0.43 0.076457425 3116.9053 86.320099 -2.9880208 2.7782794 -1070.4175 -1067.6392 - 4350 0.435 0.076457427 3061.2259 85.306966 -3.0085539 2.7456709 -1070.3849 -1067.6392 - 4400 0.44 0.076457432 3033.5229 83.703441 -3.0243431 2.6940602 -1070.3333 -1067.6392 - 4450 0.445 0.076457411 3042.5167 82.058057 -3.0397518 2.6411023 -1070.2803 -1067.6392 - 4500 0.45 0.076457387 2994.5161 81.002427 -3.0597817 2.607126 -1070.2464 -1067.6392 - 4550 0.455 0.076457413 2868.381 80.936403 -3.086593 2.605001 -1070.2442 -1067.6392 - 4600 0.46 0.076457454 2716.5128 81.904984 -3.1192161 2.6361755 -1070.2754 -1067.6392 - 4650 0.465 0.076457402 2628.691 83.537981 -3.1529675 2.6887347 -1070.328 -1067.6392 - 4700 0.47 0.076457327 2609.7253 85.196185 -3.1819342 2.7421053 -1070.3813 -1067.6392 - 4750 0.475 0.076457328 2604.4797 86.479192 -3.2088497 2.7833999 -1070.4226 -1067.6392 - 4800 0.48 0.076457385 2610.7583 87.294321 -3.242028 2.8096355 -1070.4489 -1067.6392 - 4850 0.485 0.076457398 2649.7853 87.477655 -3.2810534 2.8155362 -1070.4548 -1067.6392 - 4900 0.49 0.076457371 2678.8351 86.820207 -3.3154833 2.7943757 -1070.4336 -1067.6392 - 4950 0.495 0.076457344 2687.924 85.543066 -3.3381845 2.75327 -1070.3925 -1067.6392 - 5000 0.5 0.076457351 2720.6587 84.363474 -3.3508261 2.7153039 -1070.3545 -1067.6392 - 5050 0.505 0.076457408 2755.8292 84.030245 -3.3582878 2.7045787 -1070.3438 -1067.6392 - 5100 0.51 0.076457454 2753.2313 84.932962 -3.3648805 2.7336333 -1070.3729 -1067.6392 - 5150 0.515 0.076457453 2706.7195 86.928397 -3.3711152 2.7978579 -1070.4371 -1067.6392 - 5200 0.52 0.076457474 2678.177 89.583728 -3.3768576 2.8833218 -1070.5226 -1067.6392 - 5250 0.525 0.076457519 2699.6154 92.51484 -3.3860255 2.9776619 -1070.6169 -1067.6392 - 5300 0.53 0.076457531 2703.409 95.385751 -3.4040809 3.0700644 -1070.7093 -1067.6392 - 5350 0.535 0.076457501 2642.6927 97.779641 -3.4335521 3.1471136 -1070.7863 -1067.6392 - 5400 0.54 0.076457502 2536.3506 99.09318 -3.4686216 3.1893909 -1070.8286 -1067.6392 - 5450 0.545 0.076457526 2496.939 98.768917 -3.4975315 3.1789543 -1070.8182 -1067.6392 - 5500 0.55 0.07645752 2590.2956 96.816601 -3.5146308 3.1161175 -1070.7554 -1067.6392 - 5550 0.555 0.07645751 2736.468 93.934193 -3.5252273 3.0233449 -1070.6626 -1067.6392 - 5600 0.56 0.076457511 2852.5253 91.119522 -3.5395987 2.9327525 -1070.572 -1067.6392 - 5650 0.565 0.07645752 2911.6956 89.034641 -3.5601373 2.865649 -1070.5049 -1067.6392 - 5700 0.57 0.076457504 2872.1071 87.822315 -3.5786029 2.8266294 -1070.4659 -1067.6392 - 5750 0.575 0.076457514 2742.4368 87.594068 -3.5903293 2.8192831 -1070.4585 -1067.6392 - 5800 0.58 0.076457541 2620.8059 88.56771 -3.5997031 2.8506205 -1070.4899 -1067.6392 - 5850 0.585 0.076457558 2577.6659 90.685494 -3.6121768 2.918783 -1070.558 -1067.6392 - 5900 0.59 0.076457556 2603.2365 93.377823 -3.6265073 3.0054377 -1070.6447 -1067.6392 - 5950 0.595 0.076457545 2622.1463 95.785547 -3.6355062 3.0829322 -1070.7222 -1067.6392 - 6000 0.6 0.076457592 2584.5093 97.370119 -3.6379265 3.1339328 -1070.7732 -1067.6392 - 6050 0.605 0.076457628 2511.2983 98.197844 -3.6436108 3.1605738 -1070.7998 -1067.6392 - 6100 0.61 0.076457605 2460.1937 98.607325 -3.6641337 3.1737533 -1070.813 -1067.6392 - 6150 0.615 0.076457552 2425.1581 98.777199 -3.7023507 3.1792208 -1070.8185 -1067.6392 - 6200 0.62 0.076457529 2378.858 98.671036 -3.7529167 3.1758039 -1070.815 -1067.6392 - 6250 0.625 0.076457536 2373.6174 98.176109 -3.8075652 3.1598743 -1070.7991 -1067.6392 - 6300 0.63 0.076457584 2457.9895 97.287993 -3.8600038 3.1312896 -1070.7705 -1067.6392 - 6350 0.635 0.076457603 2571.5862 96.270876 -3.9092349 3.0985529 -1070.7378 -1067.6392 - 6400 0.64 0.076457558 2610.0136 95.435972 -3.9541069 3.0716808 -1070.7109 -1067.6392 - 6450 0.645 0.076457543 2587.7608 94.898692 -3.9898247 3.0543881 -1070.6936 -1067.6392 - 6500 0.65 0.076457571 2592.7016 94.731712 -4.0156706 3.0490137 -1070.6882 -1067.6392 - 6550 0.655 0.076457601 2601.6484 95.02635 -4.0381241 3.0584968 -1070.6977 -1067.6392 - 6600 0.66 0.076457634 2566.7083 95.637112 -4.0616073 3.0781547 -1070.7174 -1067.6392 - 6650 0.665 0.076457648 2514.9403 96.272248 -4.0866876 3.098597 -1070.7378 -1067.6392 - 6700 0.67 0.076457667 2469.8797 96.811623 -4.1148391 3.1159572 -1070.7552 -1067.6392 - 6750 0.675 0.076457679 2455.7631 97.232703 -4.1435988 3.12951 -1070.7687 -1067.6392 - 6800 0.68 0.076457673 2468.7416 97.598183 -4.1658052 3.1412733 -1070.7805 -1067.6392 - 6850 0.685 0.076457641 2449.95 98.364331 -4.1815152 3.1659323 -1070.8052 -1067.6392 - 6900 0.69 0.076457591 2353.8808 100.13602 -4.1974936 3.2229556 -1070.8622 -1067.6392 - 6950 0.695 0.076457574 2209.815 103.01374 -4.2144943 3.3155771 -1070.9548 -1067.6392 - 7000 0.7 0.07645757 2076.4955 106.68046 -4.2313525 3.4335935 -1071.0728 -1067.6392 - 7050 0.705 0.076457532 2018.5608 110.71726 -4.2520006 3.5635208 -1071.2028 -1067.6392 - 7100 0.71 0.076457492 2066.0289 114.55462 -4.2812097 3.6870294 -1071.3263 -1067.6392 - 7150 0.715 0.07645748 2155.5953 117.31153 -4.3158511 3.7757627 -1071.415 -1067.6392 - 7200 0.72 0.076457494 2209.404 118.11478 -4.3476294 3.8016159 -1071.4408 -1067.6392 - 7250 0.725 0.076457549 2217.455 116.73546 -4.3751645 3.7572213 -1071.3965 -1067.6392 - 7300 0.73 0.076457599 2194.7896 113.55484 -4.4007803 3.6548507 -1071.2941 -1067.6392 - 7350 0.735 0.07645757 2162.9678 109.25541 -4.4240013 3.5164702 -1071.1557 -1067.6392 - 7400 0.74 0.076457504 2179.1755 104.7762 -4.4454261 3.3723033 -1071.0115 -1067.6392 - 7450 0.745 0.076457518 2259.3755 101.07852 -4.4663804 3.2532905 -1070.8925 -1067.6392 - 7500 0.75 0.076457572 2343.5728 98.882923 -4.4874367 3.1826236 -1070.8219 -1067.6392 - 7550 0.755 0.076457589 2398.3228 98.458717 -4.5060637 3.1689702 -1070.8082 -1067.6392 - 7600 0.76 0.076457555 2420.6576 99.703599 -4.5200762 3.2090377 -1070.8483 -1067.6392 - 7650 0.765 0.076457552 2412.3104 102.42619 -4.5351178 3.2966665 -1070.9359 -1067.6392 - 7700 0.77 0.076457571 2388.742 106.24497 -4.5597331 3.4195769 -1071.0588 -1067.6392 - 7750 0.775 0.076457574 2379.8392 110.33126 -4.5953993 3.5510971 -1071.1903 -1067.6392 - 7800 0.78 0.076457547 2387.9692 113.47154 -4.6333122 3.6521696 -1071.2914 -1067.6392 - 7850 0.785 0.076457584 2375.3173 114.64931 -4.6633154 3.6900771 -1071.3293 -1067.6392 - 7900 0.79 0.076457607 2347.9452 113.52456 -4.6810365 3.6538759 -1071.2931 -1067.6392 - 7950 0.795 0.076457576 2325.3437 110.51925 -4.6879165 3.5571478 -1071.1964 -1067.6392 - 8000 0.8 0.076457576 2298.9574 106.80135 -4.6933853 3.4374844 -1071.0767 -1067.6392 - 8050 0.805 0.076457591 2279.7296 103.7714 -4.7072185 3.339963 -1070.9792 -1067.6392 - 8100 0.81 0.076457594 2277.4281 102.48909 -4.7324485 3.298691 -1070.9379 -1067.6392 - 8150 0.815 0.076457634 2249.9673 103.46477 -4.7678493 3.3300941 -1070.9693 -1067.6392 - 8200 0.82 0.076457642 2192.5499 106.44615 -4.8061066 3.4260518 -1071.0653 -1067.6392 - 8250 0.825 0.076457605 2153.4317 110.64954 -4.8384076 3.5613412 -1071.2006 -1067.6392 - 8300 0.83 0.07645754 2141.4131 115.25212 -4.8632501 3.709479 -1071.3487 -1067.6392 - 8350 0.835 0.076457494 2140.5445 119.40588 -4.8830278 3.8431708 -1071.4824 -1067.6392 - 8400 0.84 0.076457514 2137.788 122.1619 -4.8981204 3.9318754 -1071.5711 -1067.6392 - 8450 0.845 0.076457574 2137.0667 122.97752 -4.9139635 3.958127 -1071.5974 -1067.6392 - 8500 0.85 0.076457574 2145.0503 121.91147 -4.9379125 3.9238154 -1071.563 -1067.6392 - 8550 0.855 0.076457593 2147.0889 119.37696 -4.9688875 3.84224 -1071.4815 -1067.6392 - 8600 0.86 0.07645763 2081.6527 116.07646 -5.0006593 3.736011 -1071.3752 -1067.6392 - 8650 0.865 0.076457595 1962.5911 112.96131 -5.0308687 3.6357476 -1071.275 -1067.6392 - 8700 0.87 0.076457564 1869.6563 110.95387 -5.0615711 3.5711363 -1071.2104 -1067.6392 - 8750 0.875 0.076457589 1834.0748 110.57729 -5.0928561 3.5590158 -1071.1982 -1067.6392 - 8800 0.88 0.076457596 1854.43 111.81118 -5.1197787 3.5987297 -1071.238 -1067.6392 - 8850 0.885 0.076457575 1865.6826 114.38971 -5.1401001 3.6817215 -1071.321 -1067.6392 - 8900 0.89 0.076457601 1833.0206 117.96559 -5.1581048 3.796814 -1071.436 -1067.6392 - 8950 0.895 0.076457671 1792.8832 121.88891 -5.1778019 3.9230893 -1071.5623 -1067.6392 - 9000 0.9 0.076457726 1758.5023 125.25302 -5.2006688 4.0313657 -1071.6706 -1067.6392 - 9050 0.905 0.076457731 1735.1309 127.17393 -5.2254334 4.0931918 -1071.7324 -1067.6392 - 9100 0.91 0.076457741 1762.187 127.10436 -5.2491072 4.0909526 -1071.7302 -1067.6392 - 9150 0.915 0.076457708 1843.8804 124.99484 -5.2685152 4.0230558 -1071.6623 -1067.6392 - 9200 0.92 0.076457667 1957.8234 121.30407 -5.2827478 3.9042658 -1071.5435 -1067.6392 - 9250 0.925 0.076457686 2062.5914 117.02709 -5.2984278 3.7666077 -1071.4058 -1067.6392 - 9300 0.93 0.076457701 2105.5399 113.37476 -5.3254121 3.6490547 -1071.2883 -1067.6392 - 9350 0.935 0.076457698 2097.1011 111.14541 -5.3634987 3.5773012 -1071.2165 -1067.6392 - 9400 0.94 0.076457691 2074.0275 110.80542 -5.4086147 3.5663585 -1071.2056 -1067.6392 - 9450 0.945 0.076457741 2084.2231 112.48714 -5.4565921 3.6204859 -1071.2597 -1067.6392 - 9500 0.95 0.076457742 2098.9606 115.74433 -5.4989221 3.725321 -1071.3646 -1067.6392 - 9550 0.955 0.07645769 2076.1518 119.81614 -5.5288469 3.8563755 -1071.4956 -1067.6392 - 9600 0.96 0.076457671 2028.8268 123.94506 -5.5445735 3.989268 -1071.6285 -1067.6392 - 9650 0.965 0.0764577 2001.4552 127.5336 -5.548578 4.104768 -1071.744 -1067.6392 - 9700 0.97 0.076457704 1998.3789 130.13306 -5.5456805 4.1884336 -1071.8277 -1067.6392 - 9750 0.975 0.076457717 1975.232 131.4781 -5.5424564 4.2317247 -1071.871 -1067.6392 - 9800 0.98 0.076457754 1943.5946 131.52534 -5.543939 4.2332452 -1071.8725 -1067.6392 - 9850 0.985 0.076457767 1925.7258 130.61182 -5.5541538 4.2038429 -1071.8431 -1067.6392 - 9900 0.99 0.076457768 1912.4426 129.30485 -5.5732953 4.1617771 -1071.801 -1067.6392 - 9950 0.995 0.07645781 1906.7982 128.04744 -5.5944645 4.1213064 -1071.7605 -1067.6392 - 10000 1 0.076457853 1902.6667 127.24846 -5.6139316 4.0955905 -1071.7348 -1067.6392 - 10050 1.005 0.076457894 1903.6495 127.22624 -5.6350055 4.0948754 -1071.7341 -1067.6392 - 10100 1.01 0.076457899 1913.5279 127.69735 -5.6543581 4.1100384 -1071.7493 -1067.6392 - 10150 1.015 0.076457799 1907.6348 128.06173 -5.6658197 4.1217662 -1071.761 -1067.6392 - 10200 1.02 0.076457733 1899.2476 128.11218 -5.6733688 4.12339 -1071.7626 -1067.6392 - 10250 1.025 0.076457747 1895.8986 127.94169 -5.6840919 4.1179026 -1071.7571 -1067.6392 - 10300 1.03 0.076457816 1877.4598 127.6041 -5.7004798 4.107037 -1071.7463 -1067.6392 - 10350 1.035 0.076457876 1829.2074 127.11751 -5.7241722 4.0913757 -1071.7306 -1067.6392 - 10400 1.04 0.076457884 1806.0757 126.48167 -5.756364 4.0709108 -1071.7101 -1067.6392 - 10450 1.045 0.076457869 1822.1953 125.5947 -5.7930905 4.042363 -1071.6816 -1067.6392 - 10500 1.05 0.076457879 1827.9173 124.33858 -5.8252681 4.0019336 -1071.6412 -1067.6392 - 10550 1.055 0.076457858 1812.1963 122.79649 -5.8435788 3.9523004 -1071.5915 -1067.6392 - 10600 1.06 0.076457791 1797.2949 121.53225 -5.8488847 3.9116096 -1071.5508 -1067.6392 - 10650 1.065 0.076457757 1775.25 121.32451 -5.8518555 3.9049236 -1071.5442 -1067.6392 - 10700 1.07 0.076457792 1740.3273 122.44046 -5.8607258 3.9408413 -1071.5801 -1067.6392 - 10750 1.075 0.076457855 1729.7945 124.41086 -5.8780857 4.0042601 -1071.6435 -1067.6392 - 10800 1.08 0.076457901 1741.2893 126.28784 -5.9016509 4.0646721 -1071.7039 -1067.6392 - 10850 1.085 0.076457859 1751.6811 127.09185 -5.9236888 4.0905498 -1071.7298 -1067.6392 - 10900 1.09 0.076457795 1764.679 126.41883 -5.937278 4.0688881 -1071.7081 -1067.6392 - 10950 1.095 0.07645779 1769.3986 124.77704 -5.9433211 4.0160458 -1071.6553 -1067.6392 - 11000 1.1 0.076457827 1761.3552 123.29516 -5.9478426 3.9683506 -1071.6076 -1067.6392 - 11050 1.105 0.076457857 1751.4218 123.17488 -5.9566275 3.9644792 -1071.6037 -1067.6392 - 11100 1.11 0.076457863 1726.8666 125.22443 -5.9741936 4.0304456 -1071.6697 -1067.6392 - 11150 1.115 0.076457878 1735.2828 129.42028 -6.0014992 4.1654923 -1071.8047 -1067.6392 - 11200 1.12 0.076457903 1805.6904 134.81633 -6.0340926 4.3391683 -1071.9784 -1067.6392 - 11250 1.125 0.076457923 1847.8249 139.98198 -6.0631111 4.5054288 -1072.1447 -1067.6392 - 11300 1.13 0.076457865 1818.7912 143.90555 -6.0856034 4.6317119 -1072.2709 -1067.6392 - 11350 1.135 0.076457825 1798.9525 146.44555 -6.1101917 4.7134638 -1072.3527 -1067.6392 - 11400 1.14 0.076457815 1837.1775 147.67989 -6.1418356 4.7531917 -1072.3924 -1067.6392 - 11450 1.145 0.076457893 1909.6101 147.41836 -6.1737085 4.7447744 -1072.384 -1067.6392 - 11500 1.15 0.076457962 1946.7114 145.59364 -6.1998495 4.6860443 -1072.3253 -1067.6392 - 11550 1.155 0.076457957 1967.998 142.69304 -6.2256371 4.5926863 -1072.2319 -1067.6392 - 11600 1.16 0.076457903 2034.228 139.43936 -6.2585164 4.4879639 -1072.1272 -1067.6392 - 11650 1.165 0.076457847 2063.6908 136.1161 -6.2925345 4.3810023 -1072.0202 -1067.6392 - 11700 1.17 0.076457857 1990.1311 132.80435 -6.3184969 4.2744111 -1071.9136 -1067.6392 - 11750 1.175 0.076457901 1933.95 129.89649 -6.3394362 4.1808193 -1071.8201 -1067.6392 - 11800 1.18 0.076457953 1947.2099 127.68121 -6.3585167 4.1095189 -1071.7488 -1067.6392 - 11850 1.185 0.076457986 1940.4995 126.35451 -6.3779087 4.0668179 -1071.706 -1067.6392 - 11900 1.19 0.076457947 1896.3696 126.25109 -6.4040311 4.0634894 -1071.7027 -1067.6392 - 11950 1.195 0.076457956 1843.5682 127.5666 -6.4410172 4.1058301 -1071.7451 -1067.6392 - 12000 1.2 0.076457964 1811.4472 130.04643 -6.4846233 4.1856452 -1071.8249 -1067.6392 - 12050 1.205 0.076457972 1814.5828 133.04634 -6.5254215 4.2821996 -1071.9214 -1067.6392 - 12100 1.21 0.076457967 1813.6628 135.85077 -6.5555239 4.3724623 -1072.0117 -1067.6392 - 12150 1.215 0.076457935 1806.3763 138.19822 -6.5770911 4.448017 -1072.0872 -1067.6392 - 12200 1.22 0.076457946 1794.9644 140.31834 -6.5982636 4.5162546 -1072.1555 -1067.6392 - 12250 1.225 0.076457982 1772.5404 142.42677 -6.6192794 4.5841162 -1072.2233 -1067.6392 - 12300 1.23 0.076457963 1753.3843 144.61375 -6.6346864 4.6545058 -1072.2937 -1067.6392 - 12350 1.235 0.076457949 1737.1545 146.94235 -6.6429412 4.7294536 -1072.3687 -1067.6392 - 12400 1.24 0.076457977 1726.207 149.46271 -6.6518876 4.8105732 -1072.4498 -1067.6392 - 12450 1.245 0.076457983 1731.0662 151.80715 -6.6670425 4.8860309 -1072.5253 -1067.6392 - 12500 1.25 0.076457915 1760.4467 153.07641 -6.6813282 4.9268832 -1072.5661 -1067.6392 - 12550 1.255 0.076457879 1799.0622 152.72464 -6.6918933 4.9155611 -1072.5548 -1067.6392 - 12600 1.26 0.076457914 1822.2254 151.04918 -6.710248 4.861635 -1072.5009 -1067.6392 - 12650 1.265 0.07645795 1816.7324 148.37072 -6.7389019 4.7754268 -1072.4147 -1067.6392 - 12700 1.27 0.076457955 1812.8602 144.86733 -6.7666889 4.6626674 -1072.3019 -1067.6392 - 12750 1.275 0.076457984 1810.7634 141.22215 -6.788381 4.5453446 -1072.1846 -1067.6392 - 12800 1.28 0.076458017 1784.5198 138.39541 -6.8065328 4.4543636 -1072.0936 -1067.6392 - 12850 1.285 0.076458007 1723.1734 136.86317 -6.8200203 4.4050473 -1072.0443 -1067.6392 - 12900 1.29 0.076457981 1676.1889 136.77495 -6.8278227 4.4022078 -1072.0414 -1067.6392 - 12950 1.295 0.07645799 1686.883 138.26769 -6.8341741 4.4502528 -1072.0895 -1067.6392 - 13000 1.3 0.076458 1750.0412 141.08411 -6.841283 4.5409017 -1072.1801 -1067.6392 - 13050 1.305 0.076457933 1814.788 144.61706 -6.8510949 4.6546122 -1072.2938 -1067.6392 - 13100 1.31 0.076457918 1840.2708 148.22464 -6.8662706 4.770725 -1072.41 -1067.6392 - 13150 1.315 0.07645799 1855.2415 151.3832 -6.8883549 4.8723856 -1072.5116 -1067.6392 - 13200 1.32 0.076458049 1867.3248 153.53322 -6.9142169 4.9415857 -1072.5808 -1067.6392 - 13250 1.325 0.076458096 1847.9049 154.02873 -6.9377296 4.9575343 -1072.5968 -1067.6392 - 13300 1.33 0.076458112 1840.483 152.42018 -6.9562822 4.9057618 -1072.545 -1067.6392 - 13350 1.335 0.076458098 1855.9464 148.69839 -6.970188 4.7859732 -1072.4252 -1067.6392 - 13400 1.34 0.07645806 1820.6867 143.5401 -6.9830712 4.6199497 -1072.2592 -1067.6392 - 13450 1.345 0.076457976 1745.2435 138.19145 -6.9989611 4.4477992 -1072.087 -1067.6392 - 13500 1.35 0.076457963 1697.5473 133.92117 -7.0152512 4.310357 -1071.9496 -1067.6392 - 13550 1.355 0.076458016 1684.8882 131.80734 -7.0311044 4.2423215 -1071.8816 -1067.6392 - 13600 1.36 0.076458061 1708.2521 132.4772 -7.051885 4.2638815 -1071.9031 -1067.6392 - 13650 1.365 0.07645807 1723.4416 135.53906 -7.0750853 4.36243 -1072.0017 -1067.6392 - 13700 1.37 0.07645806 1706.999 139.94405 -7.0945976 4.5042079 -1072.1434 -1067.6392 - 13750 1.375 0.076458036 1712.8033 144.85597 -7.1159258 4.6623018 -1072.3015 -1067.6392 - 13800 1.38 0.076457971 1751.0123 149.63395 -7.1458169 4.8160849 -1072.4553 -1067.6392 - 13850 1.385 0.076458021 1772.9962 153.59227 -7.1786728 4.9434865 -1072.5827 -1067.6392 - 13900 1.39 0.076458106 1773.7385 156.28506 -7.2050465 5.030156 -1072.6694 -1067.6392 - 13950 1.395 0.076458102 1748.7335 157.81358 -7.2259294 5.0793525 -1072.7186 -1067.6392 - 14000 1.4 0.076458031 1718.5394 158.78508 -7.2557377 5.110621 -1072.7499 -1067.6392 - 14050 1.405 0.076457985 1759.6811 159.6226 -7.3026227 5.1375772 -1072.7768 -1067.6392 - 14100 1.41 0.076457949 1848.058 160.13835 -7.353886 5.154177 -1072.7934 -1067.6392 - 14150 1.415 0.07645791 1902.6843 160.00219 -7.387799 5.1497946 -1072.789 -1067.6392 - 14200 1.42 0.076457928 1921.0383 159.34446 -7.3946089 5.1286251 -1072.7679 -1067.6392 - 14250 1.425 0.076458016 1906.9383 158.81344 -7.3863965 5.111534 -1072.7508 -1067.6392 - 14300 1.43 0.076458065 1861.3283 158.866 -7.3810737 5.1132253 -1072.7525 -1067.6392 - 14350 1.435 0.076458033 1831.4331 159.34444 -7.3867848 5.1286245 -1072.7679 -1067.6392 - 14400 1.44 0.076457975 1816.0391 159.7047 -7.4029452 5.1402197 -1072.7795 -1067.6392 - 14450 1.445 0.076457983 1762.1574 159.29777 -7.4235285 5.1271223 -1072.7664 -1067.6392 - 14500 1.45 0.076458063 1709.2993 157.82112 -7.4454745 5.0795953 -1072.7188 -1067.6392 - 14550 1.455 0.076458051 1677.4867 155.54554 -7.4726077 5.0063538 -1072.6456 -1067.6392 - 14600 1.46 0.076457997 1654.1484 152.98432 -7.507262 4.9239192 -1072.5632 -1067.6392 - 14650 1.465 0.076457952 1662.1842 150.42233 -7.5432446 4.8414594 -1072.4807 -1067.6392 - 14700 1.47 0.076457903 1676.4959 147.93139 -7.5725021 4.7612867 -1072.4005 -1067.6392 - 14750 1.475 0.076457859 1647.8468 145.84289 -7.5959112 4.6940666 -1072.3333 -1067.6392 - 14800 1.48 0.076457877 1565.6357 144.8914 -7.6195017 4.6634423 -1072.3027 -1067.6392 - 14850 1.485 0.076457947 1482.0818 145.74233 -7.6439027 4.69083 -1072.3301 -1067.6392 - 14900 1.49 0.076457952 1458.8328 148.56937 -7.6680645 4.7818206 -1072.4211 -1067.6392 - 14950 1.495 0.076457894 1499.3699 152.90243 -7.6925072 4.9212832 -1072.5605 -1067.6392 - 15000 1.5 0.076457943 1551.7726 157.93125 -7.7198204 5.0831399 -1072.7224 -1067.6392 - 15050 1.505 0.076457986 1571.2434 162.8654 -7.7546524 5.2419492 -1072.8812 -1067.6392 - 15100 1.51 0.076457935 1575.6395 166.87268 -7.7966882 5.3709267 -1073.0102 -1067.6392 - 15150 1.515 0.076457852 1577.2167 169.36633 -7.8445178 5.4511868 -1073.0904 -1067.6392 - 15200 1.52 0.076457871 1551.3549 170.15934 -7.8947687 5.4767104 -1073.1159 -1067.6392 - 15250 1.525 0.076457931 1540.7825 169.38479 -7.9379114 5.4517809 -1073.091 -1067.6392 - 15300 1.53 0.076457872 1542.7519 167.721 -7.9689255 5.3982305 -1073.0375 -1067.6392 - 15350 1.535 0.076457794 1515.2436 166.07279 -7.9891151 5.3451817 -1072.9844 -1067.6392 - 15400 1.54 0.076457791 1471.3138 164.91456 -8.0001719 5.3079031 -1072.9471 -1067.6392 - 15450 1.545 0.076457806 1446.0781 164.17878 -8.005266 5.2842213 -1072.9235 -1067.6392 - 15500 1.55 0.076457866 1437.1273 163.51385 -8.007144 5.2628202 -1072.9021 -1067.6392 - 15550 1.555 0.076457955 1429.6394 162.9507 -8.0109974 5.2446946 -1072.8839 -1067.6392 - 15600 1.56 0.076457952 1428.0365 163.16031 -8.0290067 5.2514413 -1072.8907 -1067.6392 - 15650 1.565 0.076457861 1443.4131 164.39868 -8.0647449 5.291299 -1072.9305 -1067.6392 - 15700 1.57 0.076457793 1455.1522 165.85145 -8.105615 5.3380576 -1072.9773 -1067.6392 - 15750 1.575 0.076457798 1463.0529 166.37099 -8.1380795 5.3547794 -1072.994 -1067.6392 - 15800 1.58 0.0764579 1465.1315 165.43643 -8.1598171 5.3246998 -1072.9639 -1067.6392 - 15850 1.585 0.076457964 1481.9518 163.30816 -8.1737913 5.2561998 -1072.8954 -1067.6392 - 15900 1.59 0.076457915 1527.4564 160.78551 -8.1825869 5.1750065 -1072.8142 -1067.6392 - 15950 1.595 0.076457836 1575.6511 158.77652 -8.1876334 5.1103456 -1072.7496 -1067.6392 - 16000 1.6 0.07645778 1614.7527 157.95908 -8.1929355 5.0840356 -1072.7233 -1067.6392 - 16050 1.605 0.076457779 1617.7108 158.3895 -8.1978312 5.0978888 -1072.7371 -1067.6392 - 16100 1.61 0.076457748 1603.592 159.6981 -8.1974276 5.1400074 -1072.7792 -1067.6392 - 16150 1.615 0.076457683 1621.7853 161.62591 -8.1934309 5.2020553 -1072.8413 -1067.6392 - 16200 1.62 0.076457713 1666.2189 163.90851 -8.1904572 5.2755226 -1072.9148 -1067.6392 - 16250 1.625 0.076457784 1699.4521 166.19825 -8.1928336 5.3492197 -1072.9885 -1067.6392 - 16300 1.63 0.076457822 1732.0779 168.1831 -8.2032476 5.4131037 -1073.0523 -1067.6392 - 16350 1.635 0.076457792 1749.3266 169.69701 -8.2214781 5.4618299 -1073.1011 -1067.6392 - 16400 1.64 0.076457743 1727.9265 170.72169 -8.2470147 5.4948102 -1073.134 -1067.6392 - 16450 1.645 0.076457802 1695.7397 171.03962 -8.2748768 5.5050428 -1073.1443 -1067.6392 - 16500 1.65 0.076457865 1654.9001 170.1718 -8.2900487 5.4771114 -1073.1163 -1067.6392 - 16550 1.655 0.076457864 1599.4818 168.42964 -8.2855859 5.4210388 -1073.0603 -1067.6392 - 16600 1.66 0.076457829 1549.0403 167.32713 -8.2743004 5.3855536 -1073.0248 -1067.6392 - 16650 1.665 0.076457816 1552.8738 168.16653 -8.2712688 5.4125703 -1073.0518 -1067.6392 - 16700 1.67 0.076457855 1613.3994 170.72875 -8.278589 5.4950374 -1073.1343 -1067.6392 - 16750 1.675 0.076457923 1657.1911 173.60042 -8.287191 5.5874642 -1073.2267 -1067.6392 - 16800 1.68 0.076457913 1642.492 175.54043 -8.290541 5.6499049 -1073.2891 -1067.6392 - 16850 1.685 0.076457804 1591.5457 176.27819 -8.2944475 5.6736502 -1073.3129 -1067.6392 - 16900 1.69 0.076457721 1535.2384 176.07329 -8.3085794 5.6670554 -1073.3063 -1067.6392 - 16950 1.695 0.076457718 1505.622 175.05532 -8.3334071 5.6342912 -1073.2735 -1067.6392 - 17000 1.7 0.076457759 1497.9484 173.29107 -8.3636107 5.5775077 -1073.2167 -1067.6392 - 17050 1.705 0.076457839 1497.0049 170.93476 -8.3927083 5.5016678 -1073.1409 -1067.6392 - 17100 1.71 0.076457875 1511.4053 168.29935 -8.4139231 5.4168451 -1073.0561 -1067.6392 - 17150 1.715 0.076457846 1513.6863 166.13296 -8.4263326 5.3471182 -1072.9863 -1067.6392 - 17200 1.72 0.076457792 1500.5415 165.41134 -8.4331329 5.3238925 -1072.9631 -1067.6392 - 17250 1.725 0.076457779 1516.4257 166.86136 -8.4395441 5.3705623 -1073.0098 -1067.6392 - 17300 1.73 0.076457719 1560.1678 170.36031 -8.4473104 5.4831788 -1073.1224 -1067.6392 - 17350 1.735 0.076457713 1589.7681 174.76749 -8.4563024 5.6250272 -1073.2643 -1067.6392 - 17400 1.74 0.076457713 1591.6237 178.46853 -8.4713912 5.7441481 -1073.3834 -1067.6392 - 17450 1.745 0.076457675 1596.2649 179.85013 -8.4922285 5.7886159 -1073.4279 -1067.6392 - 17500 1.75 0.076457641 1584.0194 177.91175 -8.5124955 5.7262277 -1073.3655 -1067.6392 - 17550 1.755 0.076457729 1561.3047 172.8566 -8.5331849 5.5635239 -1073.2028 -1067.6392 - 17600 1.76 0.076457773 1572.5958 165.81832 -8.5554415 5.3369913 -1072.9762 -1067.6392 - 17650 1.765 0.076457741 1605.3403 158.62222 -8.5744278 5.1053792 -1072.7446 -1067.6392 - 17700 1.77 0.076457777 1625.9857 153.83663 -8.5928174 4.9513512 -1072.5906 -1067.6392 - 17750 1.775 0.076457794 1624.2493 153.59935 -8.6164551 4.9437143 -1072.5829 -1067.6392 - 17800 1.78 0.076457697 1600.4975 158.02997 -8.639484 5.0863173 -1072.7255 -1067.6392 - 17850 1.785 0.076457635 1572.3161 165.46312 -8.6573098 5.3255589 -1072.9648 -1067.6392 - 17900 1.79 0.076457609 1561.9769 173.49259 -8.6712589 5.5839937 -1073.2232 -1067.6392 - 17950 1.795 0.076457688 1562.7517 180.08491 -8.6850112 5.7961727 -1073.4354 -1067.6392 - 18000 1.8 0.076457774 1534.5231 184.30185 -8.7046968 5.9318979 -1073.5711 -1067.6392 - 18050 1.805 0.076457734 1514.7751 185.91513 -8.7282196 5.9838228 -1073.6231 -1067.6392 - 18100 1.81 0.076457673 1529.4218 185.3585 -8.7536862 5.9659073 -1073.6051 -1067.6392 - 18150 1.815 0.076457707 1528.0858 183.58143 -8.7834393 5.9087109 -1073.5479 -1067.6392 - 18200 1.82 0.0764577 1527.873 181.50762 -8.8147286 5.8419635 -1073.4812 -1067.6392 - 18250 1.825 0.076457665 1548.9614 179.99555 -8.8428647 5.7932965 -1073.4325 -1067.6392 - 18300 1.83 0.076457588 1549.3007 179.95539 -8.8681457 5.7920039 -1073.4312 -1067.6392 - 18350 1.835 0.076457533 1526.091 181.95841 -8.8948825 5.8564725 -1073.4957 -1067.6392 - 18400 1.84 0.076457629 1493.8372 185.43374 -8.9193239 5.968329 -1073.6076 -1067.6392 - 18450 1.845 0.076457747 1466.0305 188.93806 -8.9346392 6.0811179 -1073.7204 -1067.6392 - 18500 1.85 0.076457732 1463.6299 191.18823 -8.9432273 6.1535417 -1073.7928 -1067.6392 - 18550 1.855 0.076457611 1470.3581 191.71361 -8.9569487 6.1704514 -1073.8097 -1067.6392 - 18600 1.86 0.076457576 1465.3642 190.61383 -8.9856472 6.135054 -1073.7743 -1067.6392 - 18650 1.865 0.076457589 1435.5034 187.7372 -9.0216033 6.0424676 -1073.6817 -1067.6392 - 18700 1.87 0.076457602 1387.1168 182.94758 -9.0538168 5.8883099 -1073.5275 -1067.6392 - 18750 1.875 0.076457646 1370.2898 176.6874 -9.0814451 5.686821 -1073.3261 -1067.6392 - 18800 1.88 0.076457607 1396.5471 169.73777 -9.1008384 5.4631417 -1073.1024 -1067.6392 - 18850 1.885 0.076457617 1424.9718 163.2588 -9.109503 5.2546111 -1072.8938 -1067.6392 - 18900 1.89 0.076457679 1428.3173 158.69622 -9.1168953 5.107761 -1072.747 -1067.6392 - 18950 1.895 0.076457649 1439.2765 156.82172 -9.1272053 5.0474288 -1072.6867 -1067.6392 - 19000 1.9 0.076457629 1459.8802 157.73056 -9.1321959 5.0766804 -1072.7159 -1067.6392 - 19050 1.905 0.076457635 1504.363 162.01011 -9.1350256 5.2144212 -1072.8536 -1067.6392 - 19100 1.91 0.07645765 1534.7588 170.14098 -9.1510965 5.4761196 -1073.1153 -1067.6392 - 19150 1.915 0.076457653 1508.0173 180.71726 -9.1848155 5.8165254 -1073.4558 -1067.6392 - 19200 1.92 0.076457613 1467.829 190.69721 -9.2245704 6.1377378 -1073.777 -1067.6392 - 19250 1.925 0.076457631 1432.4759 197.48699 -9.2604662 6.3562721 -1073.9955 -1067.6392 - 19300 1.93 0.07645763 1411.3494 200.09216 -9.2919631 6.4401214 -1074.0794 -1067.6392 - 19350 1.935 0.076457594 1414.8241 198.83025 -9.3208023 6.399506 -1074.0387 -1067.6392 - 19400 1.94 0.076457607 1435.692 194.74665 -9.3453509 6.2680721 -1073.9073 -1067.6392 - 19450 1.945 0.076457654 1457.6905 189.4249 -9.3649457 6.0967875 -1073.736 -1067.6392 - 19500 1.95 0.076457645 1449.0474 184.9571 -9.3864711 5.9529879 -1073.5922 -1067.6392 - 19550 1.955 0.076457606 1409.8482 183.36678 -9.4200425 5.901802 -1073.541 -1067.6392 - 19600 1.96 0.076457637 1376.8581 185.3704 -9.4660084 5.9662902 -1073.6055 -1067.6392 - 19650 1.965 0.076457676 1394.1961 189.79341 -9.512099 6.1086483 -1073.7479 -1067.6392 - 19700 1.97 0.076457666 1444.3533 194.43969 -9.5410671 6.2581922 -1073.8974 -1067.6392 - 19750 1.975 0.076457652 1456.9001 197.74076 -9.5468975 6.3644397 -1074.0037 -1067.6392 - 19800 1.98 0.076457697 1416.4247 199.50327 -9.5434518 6.4211677 -1074.0604 -1067.6392 - 19850 1.985 0.07645765 1363.4589 200.03465 -9.5469461 6.4382705 -1074.0775 -1067.6392 - 19900 1.99 0.076457547 1331.9006 199.31164 -9.5615968 6.4149999 -1074.0542 -1067.6392 - 19950 1.995 0.076457526 1324.5585 197.29584 -9.5885975 6.3501197 -1073.9894 -1067.6392 - 20000 2 0.076457553 1337.069 194.04585 -9.6231448 6.2455162 -1073.8847 -1067.6392 - 20050 2.005 0.076457648 1351.0753 189.93086 -9.6575947 6.113072 -1073.7523 -1067.6392 - 20100 2.01 0.076457655 1339.7133 185.8145 -9.6913164 5.980584 -1073.6198 -1067.6392 - 20150 2.015 0.076457614 1318.0742 182.57664 -9.7225895 5.8763709 -1073.5156 -1067.6392 - 20200 2.02 0.076457601 1288.6368 180.87905 -9.7460096 5.8217325 -1073.461 -1067.6392 - 20250 2.025 0.076457595 1270.6138 181.09203 -9.7599966 5.8285875 -1073.4678 -1067.6392 - 20300 2.03 0.07645759 1297.0333 183.14558 -9.771863 5.8946825 -1073.5339 -1067.6392 - 20350 2.035 0.076457544 1322.481 186.19746 -9.7878745 5.9929098 -1073.6321 -1067.6392 - 20400 2.04 0.076457529 1321.8589 188.69758 -9.8051647 6.0733781 -1073.7126 -1067.6392 - 20450 2.045 0.076457552 1334.9839 189.43488 -9.8222144 6.0971087 -1073.7363 -1067.6392 - 20500 2.05 0.076457581 1383.7092 188.25801 -9.8390497 6.05923 -1073.6985 -1067.6392 - 20550 2.055 0.076457593 1422.9993 186.0328 -9.8547027 5.9876099 -1073.6268 -1067.6392 - 20600 2.06 0.07645748 1399.9508 184.16392 -9.8728024 5.9274586 -1073.5667 -1067.6392 - 20650 2.065 0.076457422 1335.1662 183.59411 -9.8931369 5.9091189 -1073.5483 -1067.6392 - 20700 2.07 0.076457465 1306.751 184.55079 -9.9118543 5.9399103 -1073.5791 -1067.6392 - 20750 2.075 0.076457483 1305.5888 187.07424 -9.9311695 6.0211296 -1073.6604 -1067.6392 - 20800 2.08 0.076457441 1294.1667 191.05858 -9.9508151 6.1493686 -1073.7886 -1067.6392 - 20850 2.085 0.076457401 1282.0253 196.07833 -9.9647464 6.3109334 -1073.9502 -1067.6392 - 20900 2.09 0.076457455 1292.0201 201.33144 -9.9711707 6.4800088 -1074.1192 -1067.6392 - 20950 2.095 0.076457576 1320.8835 205.6673 -9.9717153 6.6195616 -1074.2588 -1067.6392 - 21000 2.1 0.076457569 1327.4497 207.97171 -9.9627916 6.6937308 -1074.333 -1067.6392 - 21050 2.105 0.076457524 1302.0315 208.01339 -9.9425688 6.6950725 -1074.3343 -1067.6392 - 21100 2.11 0.076457555 1283.4817 206.79741 -9.9230585 6.6559351 -1074.2952 -1067.6392 - 21150 2.115 0.076457542 1295.1909 205.4375 -9.914788 6.6121654 -1074.2514 -1067.6392 - 21200 2.12 0.076457479 1321.5201 204.1527 -9.909418 6.5708132 -1074.21 -1067.6392 - 21250 2.125 0.076457453 1325.0561 202.79152 -9.8961399 6.5270024 -1074.1662 -1067.6392 - 21300 2.13 0.076457519 1301.9167 201.35361 -9.8787376 6.4807223 -1074.12 -1067.6392 - 21350 2.135 0.076457579 1274.9532 199.72664 -9.868175 6.428357 -1074.0676 -1067.6392 - 21400 2.14 0.076457544 1261.6495 197.3916 -9.8684802 6.3532018 -1073.9924 -1067.6392 - 21450 2.145 0.076457471 1267.8867 193.48031 -9.8693012 6.2273138 -1073.8665 -1067.6392 - 21500 2.15 0.076457431 1293.2863 187.70474 -9.8616374 6.0414226 -1073.6807 -1067.6392 - 21550 2.155 0.07645745 1323.0989 181.26349 -9.8574218 5.8341061 -1073.4733 -1067.6392 - 21600 2.16 0.076457464 1324.9095 175.93101 -9.8707078 5.662476 -1073.3017 -1067.6392 - 21650 2.165 0.076457483 1337.2372 172.83131 -9.9003355 5.56271 -1073.2019 -1067.6392 - 21700 2.17 0.076457536 1353.6476 172.28199 -9.9335024 5.5450296 -1073.1843 -1067.6392 - 21750 2.175 0.076457522 1337.4658 174.63693 -9.9656126 5.6208252 -1073.2601 -1067.6392 - 21800 2.18 0.076457492 1319.6144 180.27032 -10.002014 5.8021402 -1073.4414 -1067.6392 - 21850 2.185 0.076457468 1325.9534 188.6868 -10.042097 6.073031 -1073.7123 -1067.6392 - 21900 2.19 0.0764574 1351.519 198.20437 -10.076426 6.3793615 -1074.0186 -1067.6392 - 21950 2.195 0.076457412 1373.8526 206.68615 -10.099592 6.6523543 -1074.2916 -1067.6392 - 22000 2.2 0.076457518 1392.659 212.65494 -10.12001 6.8444642 -1074.4837 -1067.6392 - 22050 2.205 0.076457606 1390.3967 215.42094 -10.145572 6.93349 -1074.5727 -1067.6392 - 22100 2.21 0.076457602 1347.4452 214.94045 -10.173725 6.9180253 -1074.5573 -1067.6392 - 22150 2.215 0.076457513 1283.3202 211.98537 -10.199933 6.8229137 -1074.4621 -1067.6392 - 22200 2.22 0.076457494 1222.5665 207.95995 -10.224493 6.6933523 -1074.3326 -1067.6392 - 22250 2.225 0.076457542 1202.5195 204.45409 -10.254994 6.5805135 -1074.2197 -1067.6392 - 22300 2.23 0.076457582 1210.7113 202.41627 -10.292456 6.5149247 -1074.1542 -1067.6392 - 22350 2.235 0.076457593 1220.7645 201.90137 -10.329195 6.4983524 -1074.1376 -1067.6392 - 22400 2.24 0.076457607 1234.7446 202.62559 -10.36471 6.521662 -1074.1609 -1067.6392 - 22450 2.245 0.076457614 1256.0665 204.20591 -10.403554 6.5725258 -1074.2118 -1067.6392 - 22500 2.25 0.076457647 1289.6179 206.08787 -10.44356 6.6330979 -1074.2723 -1067.6392 - 22550 2.255 0.076457648 1318.2401 207.71118 -10.483186 6.6853454 -1074.3246 -1067.6392 - 22600 2.26 0.076457621 1319.5232 208.34289 -10.522979 6.7056776 -1074.3449 -1067.6392 - 22650 2.265 0.076457589 1316.8506 207.24251 -10.561044 6.670261 -1074.3095 -1067.6392 - 22700 2.27 0.076457617 1331.642 204.29832 -10.595084 6.5755001 -1074.2147 -1067.6392 - 22750 2.275 0.076457638 1346.6949 200.13918 -10.622417 6.4416347 -1074.0809 -1067.6392 - 22800 2.28 0.076457572 1347.787 196.067 -10.645862 6.3105686 -1073.9498 -1067.6392 - 22850 2.285 0.076457478 1357.3814 193.71126 -10.672581 6.2347474 -1073.874 -1067.6392 - 22900 2.29 0.076457506 1359.0604 194.23136 -10.704942 6.2514872 -1073.8907 -1067.6392 - 22950 2.295 0.07645755 1347.1653 197.67464 -10.741957 6.3623116 -1074.0015 -1067.6392 - 23000 2.3 0.076457564 1321.3672 202.79941 -10.780161 6.5272563 -1074.1665 -1067.6392 - 23050 2.305 0.076457626 1300.8493 207.8112 -10.812965 6.6885649 -1074.3278 -1067.6392 - 23100 2.31 0.076457662 1289.7113 211.5894 -10.839288 6.8101691 -1074.4494 -1067.6392 - 23150 2.315 0.076457654 1266.9494 213.84528 -10.86234 6.8827763 -1074.522 -1067.6392 - 23200 2.32 0.076457651 1237.4556 214.46793 -10.878861 6.9028167 -1074.542 -1067.6392 - 23250 2.325 0.076457588 1216.4817 213.53906 -10.88737 6.8729203 -1074.5122 -1067.6392 - 23300 2.33 0.076457561 1198.6768 211.4015 -10.892244 6.8041213 -1074.4434 -1067.6392 - 23350 2.335 0.076457617 1218.46 208.62206 -10.896503 6.714663 -1074.3539 -1067.6392 - 23400 2.34 0.076457697 1274.0141 206.18082 -10.898818 6.6360899 -1074.2753 -1067.6392 - 23450 2.345 0.076457697 1310.0462 205.39475 -10.899188 6.6107893 -1074.25 -1067.6392 - 23500 2.35 0.076457625 1309.8688 206.85671 -10.898274 6.6578437 -1074.2971 -1067.6392 - 23550 2.355 0.076457607 1294.4375 210.05998 -10.904793 6.7609436 -1074.4002 -1067.6392 - 23600 2.36 0.076457638 1272.3829 213.64213 -10.924411 6.8762376 -1074.5155 -1067.6392 - 23650 2.365 0.07645764 1263.3834 215.89726 -10.943246 6.9488208 -1074.5881 -1067.6392 - 23700 2.37 0.0764576 1265.3339 216.28708 -10.95133 6.9613674 -1074.6006 -1067.6392 - 23750 2.375 0.076457533 1265.7883 215.64775 -10.954658 6.9407901 -1074.58 -1067.6392 - 23800 2.38 0.076457509 1270.324 215.14847 -10.964811 6.9247203 -1074.564 -1067.6392 - 23850 2.385 0.076457647 1295.1389 215.59482 -10.992719 6.9390865 -1074.5783 -1067.6392 - 23900 2.39 0.07645774 1317.1304 216.50299 -11.032267 6.9683166 -1074.6075 -1067.6392 - 23950 2.395 0.076457678 1323.3993 216.86149 -11.06922 6.9798554 -1074.6191 -1067.6392 - 24000 2.4 0.076457616 1327.0079 216.51416 -11.098994 6.9686763 -1074.6079 -1067.6392 - 24050 2.405 0.076457602 1347.1187 215.98329 -11.123989 6.9515898 -1074.5908 -1067.6392 - 24100 2.41 0.076457633 1373.0058 215.6582 -11.147405 6.9411267 -1074.5804 -1067.6392 - 24150 2.415 0.076457606 1357.3622 215.33306 -11.168833 6.9306616 -1074.5699 -1067.6392 - 24200 2.42 0.076457558 1293.9783 214.6673 -11.190176 6.9092338 -1074.5485 -1067.6392 - 24250 2.425 0.076457575 1262.6983 213.59841 -11.211793 6.8748305 -1074.5141 -1067.6392 - 24300 2.43 0.076457586 1296.1082 212.60059 -11.234851 6.8427151 -1074.4819 -1067.6392 - 24350 2.435 0.07645758 1338.5152 212.36533 -11.263922 6.8351428 -1074.4744 -1067.6392 - 24400 2.44 0.07645762 1359.7328 212.76414 -11.288804 6.847979 -1074.4872 -1067.6392 - 24450 2.445 0.076457613 1354.6032 213.05104 -11.296422 6.8572131 -1074.4964 -1067.6392 - 24500 2.45 0.07645752 1340.1858 212.64499 -11.294481 6.8441441 -1074.4834 -1067.6392 - 24550 2.455 0.07645749 1331.5151 211.50434 -11.306624 6.8074314 -1074.4467 -1067.6392 - 24600 2.46 0.076457509 1316.1319 209.75998 -11.338874 6.7512878 -1074.3905 -1067.6392 - 24650 2.465 0.076457501 1303.2352 208.01652 -11.382268 6.6951732 -1074.3344 -1067.6392 - 24700 2.47 0.076457554 1316.5042 207.54508 -11.432653 6.6799995 -1074.3192 -1067.6392 - 24750 2.475 0.076457644 1323.4729 209.08952 -11.480943 6.7297085 -1074.3689 -1067.6392 - 24800 2.48 0.076457563 1316.2449 212.60405 -11.521223 6.8428264 -1074.4821 -1067.6392 - 24850 2.485 0.076457464 1303.023 217.39017 -11.549403 6.9968714 -1074.6361 -1067.6392 - 24900 2.49 0.076457476 1306.7431 222.37347 -11.558822 7.1572628 -1074.7965 -1067.6392 - 24950 2.495 0.07645745 1300.9383 226.66891 -11.5504 7.2955148 -1074.9347 -1067.6392 - 25000 2.5 0.076457461 1270.8966 229.83334 -11.536542 7.3973644 -1075.0366 -1067.6392 - 25050 2.505 0.076457456 1266.2646 231.90105 -11.533642 7.4639151 -1075.1031 -1067.6392 - 25100 2.51 0.076457446 1270.2017 233.06025 -11.547509 7.501225 -1075.1405 -1067.6392 - 25150 2.515 0.07645757 1231.6171 233.15738 -11.56954 7.5043513 -1075.1436 -1067.6392 - 25200 2.52 0.076457709 1191.0767 231.73714 -11.589225 7.4586397 -1075.0979 -1067.6392 - 25250 2.525 0.076457772 1193.1019 228.87762 -11.611584 7.366604 -1075.0058 -1067.6392 - 25300 2.53 0.076457705 1202.8442 225.48075 -11.647482 7.257273 -1074.8965 -1067.6392 - 25350 2.535 0.076457601 1201.3602 222.49225 -11.687125 7.1610856 -1074.8003 -1067.6392 - 25400 2.54 0.076457625 1191.7307 220.47028 -11.711225 7.0960072 -1074.7352 -1067.6392 - 25450 2.545 0.076457676 1184.558 219.7896 -11.72244 7.074099 -1074.7133 -1067.6392 - 25500 2.55 0.07645769 1209.0131 220.21101 -11.729634 7.0876623 -1074.7269 -1067.6392 - 25550 2.555 0.076457694 1252.4527 221.39919 -11.740381 7.1259047 -1074.7651 -1067.6392 - 25600 2.56 0.076457651 1266.8561 223.37443 -11.758317 7.1894793 -1074.8287 -1067.6392 - 25650 2.565 0.076457702 1260.0162 226.18443 -11.779767 7.2799214 -1074.9192 -1067.6392 - 25700 2.57 0.076457766 1258.0807 229.46946 -11.803244 7.3856527 -1075.0249 -1067.6392 - 25750 2.575 0.0764577 1260.0577 231.96891 -11.827028 7.4660992 -1075.1053 -1067.6392 - 25800 2.58 0.07645766 1263.5682 232.00397 -11.843175 7.4672278 -1075.1065 -1067.6392 - 25850 2.585 0.076457679 1267.6331 229.22367 -11.852724 7.3777416 -1075.017 -1067.6392 - 25900 2.59 0.076457667 1273.4873 224.95936 -11.864844 7.2404915 -1074.8797 -1067.6392 - 25950 2.595 0.076457638 1259.3238 220.69283 -11.875369 7.1031702 -1074.7424 -1067.6392 - 26000 2.6 0.07645756 1234.4517 217.53504 -11.87838 7.0015342 -1074.6408 -1067.6392 - 26050 2.605 0.076457531 1223.5843 216.47883 -11.885283 6.967539 -1074.6068 -1067.6392 - 26100 2.61 0.076457579 1239.4383 217.6799 -11.906525 7.0061965 -1074.6454 -1067.6392 - 26150 2.615 0.076457676 1254.9755 220.14626 -11.9364 7.0855781 -1074.7248 -1067.6392 - 26200 2.62 0.076457691 1263.4276 222.78599 -11.96794 7.17054 -1074.8098 -1067.6392 - 26250 2.625 0.076457661 1290.9982 225.11879 -12.002676 7.2456229 -1074.8849 -1067.6392 - 26300 2.63 0.076457625 1320.5003 226.53955 -12.032325 7.2913511 -1074.9306 -1067.6392 - 26350 2.635 0.076457604 1325.6925 226.42099 -12.045972 7.2875353 -1074.9268 -1067.6392 - 26400 2.64 0.076457635 1323.8314 225.04813 -12.050265 7.2433489 -1074.8826 -1067.6392 - 26450 2.645 0.076457683 1337.7763 223.39584 -12.056562 7.1901684 -1074.8294 -1067.6392 - 26500 2.65 0.076457646 1356.26 222.47285 -12.072437 7.1604612 -1074.7997 -1067.6392 - 26550 2.655 0.076457593 1368.7452 222.81131 -12.102517 7.1713548 -1074.8106 -1067.6392 - 26600 2.66 0.076457577 1372.4772 224.2612 -12.136283 7.2180208 -1074.8573 -1067.6392 - 26650 2.665 0.076457669 1353.1116 226.93203 -12.15666 7.3039835 -1074.9432 -1067.6392 - 26700 2.67 0.07645782 1296.4345 231.54488 -12.162395 7.4524517 -1075.0917 -1067.6392 - 26750 2.675 0.07645786 1233.171 238.00107 -12.16795 7.6602491 -1075.2995 -1067.6392 - 26800 2.68 0.0764578 1205.1226 244.60391 -12.18481 7.8727668 -1075.512 -1067.6392 - 26850 2.685 0.076457751 1203.9449 249.24116 -12.214765 8.0220202 -1075.6613 -1067.6392 - 26900 2.69 0.076457871 1220.793 250.32595 -12.247789 8.0569351 -1075.6962 -1067.6392 - 26950 2.695 0.07645797 1250.922 247.65941 -12.281839 7.9711102 -1075.6103 -1067.6392 - 27000 2.7 0.076457916 1272.2527 242.25891 -12.319204 7.7972911 -1075.4365 -1067.6392 - 27050 2.705 0.076457909 1260.7801 235.6016 -12.35094 7.5830204 -1075.2223 -1067.6392 - 27100 2.71 0.076457849 1229.7859 229.49227 -12.367756 7.3863867 -1075.0256 -1067.6392 - 27150 2.715 0.076457776 1230.1984 225.87326 -12.37385 7.2699062 -1074.9091 -1067.6392 - 27200 2.72 0.076457788 1256.5205 226.01981 -12.383103 7.2746231 -1074.9139 -1067.6392 - 27250 2.725 0.076457742 1269.109 229.57592 -12.401772 7.3890791 -1075.0283 -1067.6392 - 27300 2.73 0.076457757 1278.2216 234.37745 -12.41951 7.5436201 -1075.1829 -1067.6392 - 27350 2.735 0.076457815 1281.9146 237.72622 -12.426299 7.651403 -1075.2906 -1067.6392 - 27400 2.74 0.076457895 1266.5327 238.04161 -12.428658 7.6615539 -1075.3008 -1067.6392 - 27450 2.745 0.076457976 1238.9201 235.37217 -12.441314 7.5756359 -1075.2149 -1067.6392 - 27500 2.75 0.076457843 1230.4481 230.70667 -12.466737 7.4254733 -1075.0647 -1067.6392 - 27550 2.755 0.076457656 1236.7255 225.51713 -12.497899 7.2584439 -1074.8977 -1067.6392 - 27600 2.76 0.07645776 1238.11 221.28548 -12.52521 7.1222449 -1074.7615 -1067.6392 - 27650 2.765 0.076457889 1218.4037 219.08795 -12.543581 7.0515156 -1074.6907 -1067.6392 - 27700 2.77 0.076457882 1198.4777 219.33613 -12.554891 7.0595037 -1074.6987 -1067.6392 - 27750 2.775 0.076457863 1183.089 221.96976 -12.561518 7.144269 -1074.7835 -1067.6392 - 27800 2.78 0.076457885 1169.37 227.37353 -12.573341 7.3181935 -1074.9574 -1067.6392 - 27850 2.785 0.076457897 1169.7411 235.91312 -12.602269 7.5930469 -1075.2323 -1067.6392 - 27900 2.79 0.076457851 1151.3464 246.28711 -12.644365 7.9269419 -1075.5662 -1067.6392 - 27950 2.795 0.076457843 1106.9771 255.46726 -12.682364 8.2224121 -1075.8616 -1067.6392 - 28000 2.8 0.076457826 1068.9543 260.54346 -12.70329 8.3857935 -1076.025 -1067.6392 - 28050 2.805 0.076457783 1046.8631 260.38287 -12.707616 8.3806246 -1076.0199 -1067.6392 - 28100 2.81 0.076457851 1035.4028 255.75262 -12.701329 8.2315965 -1075.8708 -1067.6392 - 28150 2.815 0.076457914 1039.8478 248.80323 -12.698053 8.0079252 -1075.6472 -1067.6392 - 28200 2.82 0.076457945 1077.5288 241.99763 -12.714207 7.7888815 -1075.4281 -1067.6392 - 28250 2.825 0.076457907 1106.7726 236.8129 -12.748192 7.6220071 -1075.2612 -1067.6392 - 28300 2.83 0.076457858 1088.3383 233.07492 -12.770565 7.501697 -1075.1409 -1067.6392 - 28350 2.835 0.076457962 1067.6408 230.2341 -12.762291 7.4102632 -1075.0495 -1067.6392 - 28400 2.84 0.076458053 1085.7765 228.74782 -12.741859 7.362426 -1075.0017 -1067.6392 - 28450 2.845 0.076458069 1116.0156 229.35012 -12.732966 7.3818115 -1075.021 -1067.6392 - 28500 2.85 0.07645799 1140.0561 231.95241 -12.737452 7.4655684 -1075.1048 -1067.6392 - 28550 2.855 0.076457881 1175.3679 235.63809 -12.744967 7.5841948 -1075.2234 -1067.6392 - 28600 2.86 0.076457945 1191.5122 239.06582 -12.744692 7.6945191 -1075.3338 -1067.6392 - 28650 2.865 0.076458033 1165.8181 241.0619 -12.730571 7.7587645 -1075.398 -1067.6392 - 28700 2.87 0.076458003 1144.2872 241.42924 -12.708938 7.7705875 -1075.4098 -1067.6392 - 28750 2.875 0.076457916 1156.9296 241.00794 -12.69273 7.7570275 -1075.3963 -1067.6392 - 28800 2.88 0.076457978 1169.6062 241.01439 -12.691343 7.7572351 -1075.3965 -1067.6392 - 28850 2.885 0.076458067 1153.2461 242.11608 -12.703125 7.7926941 -1075.4319 -1067.6392 - 28900 2.89 0.076458128 1137.1648 244.24646 -12.730476 7.8612619 -1075.5005 -1067.6392 - 28950 2.895 0.076458132 1144.0676 245.87591 -12.765806 7.9137071 -1075.5529 -1067.6392 - 29000 2.9 0.076458055 1166.7003 244.81325 -12.786467 7.8795045 -1075.5187 -1067.6392 - 29050 2.905 0.076458115 1201.626 240.80417 -12.786117 7.7504692 -1075.3897 -1067.6392 - 29100 2.91 0.076458234 1227.2794 235.81398 -12.775018 7.5898561 -1075.2291 -1067.6392 - 29150 2.915 0.076458217 1233.5955 232.10337 -12.761015 7.470427 -1075.1097 -1067.6392 - 29200 2.92 0.076458111 1222.4273 231.10647 -12.757278 7.4383412 -1075.0776 -1067.6392 - 29250 2.925 0.076458074 1212.9521 232.98759 -12.778062 7.4988864 -1075.1381 -1067.6392 - 29300 2.93 0.076458082 1220.2844 236.56821 -12.814589 7.6141315 -1075.2534 -1067.6392 - 29350 2.935 0.076458085 1197.6267 240.71244 -12.847172 7.7475166 -1075.3867 -1067.6392 - 29400 2.94 0.076458174 1166.2296 245.3581 -12.871897 7.8970407 -1075.5363 -1067.6392 - 29450 2.945 0.0764582 1162.6548 250.15917 -12.892997 8.0515671 -1075.6908 -1067.6392 - 29500 2.95 0.076458192 1166.7685 253.39653 -12.905195 8.1557639 -1075.795 -1067.6392 - 29550 2.955 0.076458187 1155.8258 253.69254 -12.906863 8.1652912 -1075.8045 -1067.6392 - 29600 2.96 0.076458159 1155.2633 251.58259 -12.911192 8.0973809 -1075.7366 -1067.6392 - 29650 2.965 0.076458142 1187.0841 248.958 -12.92707 8.0129065 -1075.6521 -1067.6392 - 29700 2.97 0.076458107 1216.9951 247.40312 -12.945328 7.9628616 -1075.6021 -1067.6392 - 29750 2.975 0.076458054 1194.8857 246.85295 -12.955382 7.9451538 -1075.5844 -1067.6392 - 29800 2.98 0.076458024 1170.1087 246.10026 -12.960888 7.9209279 -1075.5602 -1067.6392 - 29850 2.985 0.076458073 1169.1596 244.20885 -12.971119 7.8600515 -1075.4993 -1067.6392 - 29900 2.99 0.076458181 1160.4286 240.86241 -12.984094 7.7523436 -1075.3916 -1067.6392 - 29950 2.995 0.076458232 1131.8843 236.46352 -12.994209 7.6107619 -1075.25 -1067.6392 - 30000 3 0.076458157 1094.5416 232.18947 -13.0017 7.4731984 -1075.1124 -1067.6392 - 30050 3.005 0.076458011 1065.8494 229.55114 -13.006404 7.3882816 -1075.0275 -1067.6392 - 30100 3.01 0.076458026 1061.4657 229.77899 -13.012924 7.3956153 -1075.0348 -1067.6392 - 30150 3.015 0.076458159 1064.4309 232.81858 -13.028261 7.4934467 -1075.1327 -1067.6392 - 30200 3.02 0.076458266 1064.5403 237.18963 -13.051358 7.6341323 -1075.2734 -1067.6392 - 30250 3.025 0.076458254 1077.435 241.1768 -13.07564 7.7624624 -1075.4017 -1067.6392 - 30300 3.03 0.076458129 1120.7955 244.00429 -13.099282 7.8534675 -1075.4927 -1067.6392 - 30350 3.035 0.076458123 1166.6115 245.76237 -13.120127 7.9100525 -1075.5493 -1067.6392 - 30400 3.04 0.076458222 1186.7887 246.73143 -13.12997 7.9412425 -1075.5805 -1067.6392 - 30450 3.045 0.076458192 1210.3729 247.3058 -13.131142 7.9597292 -1075.599 -1067.6392 - 30500 3.05 0.076458205 1226.7005 247.41892 -13.129466 7.9633701 -1075.6026 -1067.6392 - 30550 3.055 0.076458239 1218.1054 246.53578 -13.123602 7.9349454 -1075.5742 -1067.6392 - 30600 3.06 0.076458222 1213.5049 244.89144 -13.119076 7.882021 -1075.5213 -1067.6392 - 30650 3.065 0.076458209 1197.742 243.51998 -13.124172 7.8378794 -1075.4771 -1067.6392 - 30700 3.07 0.076458217 1173.0375 243.32265 -13.142559 7.8315283 -1075.4708 -1067.6392 - 30750 3.075 0.076458232 1174.7744 244.4044 -13.175375 7.8663454 -1075.5056 -1067.6392 - 30800 3.08 0.076458215 1182.8312 245.99614 -13.218442 7.9175767 -1075.5568 -1067.6392 - 30850 3.085 0.076458183 1183.66 247.03526 -13.258527 7.9510216 -1075.5903 -1067.6392 - 30900 3.09 0.076458319 1177.992 247.2078 -13.284596 7.9565748 -1075.5958 -1067.6392 - 30950 3.095 0.076458373 1176.7211 247.34132 -13.301899 7.9608722 -1075.6001 -1067.6392 - 31000 3.1 0.076458253 1164.7417 248.53603 -13.327025 7.9993251 -1075.6386 -1067.6392 - 31050 3.105 0.076458217 1128.9001 250.94808 -13.365858 8.0769586 -1075.7162 -1067.6392 - 31100 3.11 0.076458294 1092.9077 253.74162 -13.407353 8.1668708 -1075.8061 -1067.6392 - 31150 3.115 0.076458358 1079.4871 256.46396 -13.445278 8.2544917 -1075.8937 -1067.6392 - 31200 3.12 0.076458421 1088.7747 259.60213 -13.488098 8.3554961 -1075.9947 -1067.6392 - 31250 3.125 0.07645843 1133.6001 263.188 -13.540135 8.47091 -1076.1101 -1067.6392 - 31300 3.13 0.076458393 1192.6693 265.96082 -13.591815 8.5601553 -1076.1994 -1067.6392 - 31350 3.135 0.076458398 1206.7015 266.41337 -13.631689 8.5747211 -1076.214 -1067.6392 - 31400 3.14 0.07645845 1184.8303 264.21376 -13.660682 8.5039248 -1076.1432 -1067.6392 - 31450 3.145 0.07645848 1183.6347 260.39213 -13.689676 8.380923 -1076.0202 -1067.6392 - 31500 3.15 0.076458598 1199.1745 256.21199 -13.723387 8.2463816 -1075.8856 -1067.6392 - 31550 3.155 0.076458602 1226.3861 252.38445 -13.753029 8.1231895 -1075.7624 -1067.6392 - 31600 3.16 0.076458505 1232.7936 249.62393 -13.772372 8.0343401 -1075.6736 -1067.6392 - 31650 3.165 0.076458472 1194.1646 248.63142 -13.78451 8.0023952 -1075.6416 -1067.6392 - 31700 3.17 0.076458402 1135.0204 248.67712 -13.784757 8.0038662 -1075.6431 -1067.6392 - 31750 3.175 0.076458444 1088.5207 248.0804 -13.772118 7.9846602 -1075.6239 -1067.6392 - 31800 3.18 0.076458483 1079.5555 246.27927 -13.761932 7.9266895 -1075.5659 -1067.6392 - 31850 3.185 0.076458412 1103.2185 244.3339 -13.766697 7.8640762 -1075.5033 -1067.6392 - 31900 3.19 0.07645842 1120.0872 243.8787 -13.782801 7.8494252 -1075.4887 -1067.6392 - 31950 3.195 0.076458479 1119.4512 245.95725 -13.799444 7.9163248 -1075.5556 -1067.6392 - 32000 3.2 0.07645851 1092.4855 250.30658 -13.803665 8.0563117 -1075.6955 -1067.6392 - 32050 3.205 0.076458415 1067.424 255.82203 -13.785579 8.2338307 -1075.8731 -1067.6392 - 32100 3.21 0.076458345 1068.4429 261.44517 -13.748535 8.4148156 -1076.054 -1067.6392 - 32150 3.215 0.07645841 1080.7046 266.36957 -13.713453 8.5733114 -1076.2125 -1067.6392 - 32200 3.22 0.076458507 1092.5849 269.83978 -13.708135 8.6850028 -1076.3242 -1067.6392 - 32250 3.225 0.076458535 1099.8414 270.7057 -13.73358 8.7128731 -1076.3521 -1067.6392 - 32300 3.23 0.076458534 1114.7135 268.29144 -13.763677 8.6351683 -1076.2744 -1067.6392 - 32350 3.235 0.076458458 1109.1702 263.87403 -13.783235 8.4929906 -1076.1322 -1067.6392 - 32400 3.24 0.07645842 1084.0276 259.90176 -13.803644 8.36514 -1076.0044 -1067.6392 - 32450 3.245 0.076458464 1083.1937 257.32785 -13.835634 8.2822966 -1075.9215 -1067.6392 - 32500 3.25 0.07645845 1114.4646 255.14878 -13.870961 8.2121616 -1075.8514 -1067.6392 - 32550 3.255 0.076458381 1152.8289 252.6422 -13.897547 8.1314852 -1075.7707 -1067.6392 - 32600 3.26 0.076458468 1177.486 250.67802 -13.912211 8.0682668 -1075.7075 -1067.6392 - 32650 3.265 0.076458565 1185.3078 250.60277 -13.918256 8.0658447 -1075.7051 -1067.6392 - 32700 3.27 0.076458542 1191.2786 252.7908 -13.926328 8.136268 -1075.7755 -1067.6392 - 32750 3.275 0.076458529 1180.3288 256.6616 -13.948559 8.2608527 -1075.9001 -1067.6392 - 32800 3.28 0.076458451 1153.7783 261.08347 -13.985264 8.4031741 -1076.0424 -1067.6392 - 32850 3.285 0.076458392 1133.2496 264.84942 -14.024763 8.5243841 -1076.1636 -1067.6392 - 32900 3.29 0.076458438 1115.3658 267.38276 -14.053439 8.6059217 -1076.2452 -1067.6392 - 32950 3.295 0.076458471 1127.683 269.00733 -14.070131 8.6582097 -1076.2974 -1067.6392 - 33000 3.3 0.076458479 1149.7773 269.98003 -14.072925 8.6895169 -1076.3287 -1067.6392 - 33050 3.305 0.076458432 1151.5261 270.25086 -14.062159 8.6982337 -1076.3375 -1067.6392 - 33100 3.31 0.076458345 1155.116 269.80119 -14.049957 8.6837609 -1076.323 -1067.6392 - 33150 3.315 0.076458436 1135.61 268.22847 -14.036071 8.6331415 -1076.2724 -1067.6392 - 33200 3.32 0.076458577 1111.738 265.73519 -14.027508 8.5528932 -1076.1921 -1067.6392 - 33250 3.325 0.076458535 1116.9245 263.26799 -14.038682 8.4734846 -1076.1127 -1067.6392 - 33300 3.33 0.076458501 1131.8225 261.47169 -14.068281 8.4156693 -1076.0549 -1067.6392 - 33350 3.335 0.076458475 1120.8199 260.14815 -14.108099 8.3730701 -1076.0123 -1067.6392 - 33400 3.34 0.076458435 1094.4035 258.29932 -14.149771 8.3135641 -1075.9528 -1067.6392 - 33450 3.345 0.076458459 1082.1878 255.19265 -14.184258 8.2135735 -1075.8528 -1067.6392 - 33500 3.35 0.076458528 1083.2242 251.14433 -14.202792 8.0832751 -1075.7225 -1067.6392 - 33550 3.355 0.076458529 1103.4532 247.60346 -14.210592 7.9693094 -1075.6085 -1067.6392 - 33600 3.36 0.076458486 1137.7183 246.24059 -14.222506 7.9254445 -1075.5647 -1067.6392 - 33650 3.365 0.076458516 1150.4421 247.37214 -14.233399 7.9618644 -1075.6011 -1067.6392 - 33700 3.37 0.076458507 1143.7496 250.70305 -14.237383 8.0690723 -1075.7083 -1067.6392 - 33750 3.375 0.076458425 1135.9529 256.43973 -14.24743 8.2537116 -1075.8929 -1067.6392 - 33800 3.38 0.076458392 1126.2288 264.31662 -14.271937 8.5072354 -1076.1465 -1067.6392 - 33850 3.385 0.07645848 1105.1309 272.68103 -14.305504 8.7764506 -1076.4157 -1067.6392 - 33900 3.39 0.076458564 1085.1215 279.2817 -14.345574 8.9888984 -1076.6281 -1067.6392 - 33950 3.395 0.076458555 1076.9206 282.71636 -14.394902 9.0994454 -1076.7387 -1067.6392 - 34000 3.4 0.076458512 1086.4333 282.84295 -14.446959 9.10352 -1076.7428 -1067.6392 - 34050 3.405 0.07645848 1099.4638 280.63434 -14.486843 9.0324339 -1076.6717 -1067.6392 - 34100 3.41 0.076458382 1093.368 278.40903 -14.515246 8.9608108 -1076.6 -1067.6392 - 34150 3.415 0.076458423 1088.8094 278.43798 -14.545814 8.9617425 -1076.601 -1067.6392 - 34200 3.42 0.076458529 1070.3036 280.46333 -14.587151 9.0269298 -1076.6662 -1067.6392 - 34250 3.425 0.076458454 1052.8089 281.70843 -14.639127 9.0670046 -1076.7062 -1067.6392 - 34300 3.43 0.076458324 1067.0859 279.60749 -14.693017 8.9993839 -1076.6386 -1067.6392 - 34350 3.435 0.07645844 1078.4994 274.06548 -14.735218 8.8210102 -1076.4602 -1067.6392 - 34400 3.44 0.076458576 1065.194 267.45347 -14.7594 8.6081974 -1076.2474 -1067.6392 - 34450 3.445 0.076458493 1044.6764 262.6287 -14.769981 8.4529085 -1076.0921 -1067.6392 - 34500 3.45 0.076458493 1031.1327 261.22703 -14.778334 8.4077947 -1076.047 -1067.6392 - 34550 3.455 0.076458662 1001.3241 263.2628 -14.787349 8.4733177 -1076.1125 -1067.6392 - 34600 3.46 0.076458744 972.94591 267.72772 -14.797072 8.6170244 -1076.2563 -1067.6392 - 34650 3.465 0.076458639 990.70544 272.38909 -14.802726 8.7670542 -1076.4063 -1067.6392 - 34700 3.47 0.0764585 1025.1974 274.74718 -14.798109 8.8429511 -1076.4822 -1067.6392 - 34750 3.475 0.076458513 1061.0651 274.45565 -14.798547 8.8335681 -1076.4728 -1067.6392 - 34800 3.48 0.076458471 1123.989 273.19344 -14.824615 8.7929427 -1076.4322 -1067.6392 - 34850 3.485 0.07645842 1192.2777 272.33238 -14.868829 8.7652289 -1076.4045 -1067.6392 - 34900 3.49 0.076458595 1219.3889 271.4554 -14.89476 8.7370026 -1076.3762 -1067.6392 - 34950 3.495 0.076458742 1206.5159 270.21752 -14.898336 8.6971606 -1076.3364 -1067.6392 - 35000 3.5 0.076458628 1197.9968 269.40678 -14.907691 8.6710664 -1076.3103 -1067.6392 - 35050 3.505 0.076458539 1199.2614 270.09068 -14.937895 8.6930781 -1076.3323 -1067.6392 - 35100 3.51 0.076458542 1195.6006 272.66182 -14.979789 8.7758322 -1076.4151 -1067.6392 - 35150 3.515 0.076458532 1184.1758 276.31503 -15.015192 8.8934136 -1076.5326 -1067.6392 - 35200 3.52 0.076458506 1177.2232 279.44786 -15.03426 8.9942462 -1076.6335 -1067.6392 - 35250 3.525 0.076458498 1165.906 281.04835 -15.043888 9.0457593 -1076.685 -1067.6392 - 35300 3.53 0.076458547 1122.7378 281.23471 -15.05217 9.0517575 -1076.691 -1067.6392 - 35350 3.535 0.07645859 1089.1258 281.40192 -15.068688 9.0571393 -1076.6964 -1067.6392 - 35400 3.54 0.076458581 1071.6628 283.20912 -15.098467 9.1153054 -1076.7545 -1067.6392 - 35450 3.545 0.076458561 1061.0287 286.5938 -15.126471 9.224244 -1076.8635 -1067.6392 - 35500 3.55 0.076458577 1073.4644 290.07888 -15.144262 9.336414 -1076.9756 -1067.6392 - 35550 3.555 0.076458498 1108.9235 291.84501 -15.154818 9.3932582 -1077.0325 -1067.6392 - 35600 3.56 0.076458531 1144.2606 290.86582 -15.170369 9.3617421 -1077.001 -1067.6392 - 35650 3.565 0.076458588 1167.6046 287.19918 -15.196185 9.2437284 -1076.883 -1067.6392 - 35700 3.57 0.07645856 1179.6333 282.11602 -15.229568 9.0801229 -1076.7194 -1067.6392 - 35750 3.575 0.076458589 1168.0753 277.29692 -15.269679 8.9250164 -1076.5642 -1067.6392 - 35800 3.58 0.076458495 1150.8477 273.36789 -15.307138 8.7985576 -1076.4378 -1067.6392 - 35850 3.585 0.076458358 1134.8391 270.61841 -15.336424 8.7100634 -1076.3493 -1067.6392 - 35900 3.59 0.076458438 1131.4083 269.61936 -15.365921 8.6779085 -1076.3171 -1067.6392 - 35950 3.595 0.076458656 1156.3165 270.44071 -15.401487 8.704344 -1076.3436 -1067.6392 - 36000 3.6 0.076458662 1183.5929 272.83276 -15.446386 8.7813341 -1076.4206 -1067.6392 - 36050 3.605 0.076458511 1175.8081 276.36312 -15.497044 8.8949617 -1076.5342 -1067.6392 - 36100 3.61 0.076458487 1137.1434 280.08603 -15.537522 9.0147862 -1076.654 -1067.6392 - 36150 3.615 0.076458492 1123.4073 282.9067 -15.557122 9.1055719 -1076.7448 -1067.6392 - 36200 3.62 0.076458546 1127.9754 284.11149 -15.565186 9.1443489 -1076.7836 -1067.6392 - 36250 3.625 0.076458599 1122.4255 283.84703 -15.578297 9.1358371 -1076.7751 -1067.6392 - 36300 3.63 0.07645858 1122.041 283.02913 -15.596263 9.1095122 -1076.7487 -1067.6392 - 36350 3.635 0.076458589 1127.0768 282.3869 -15.600033 9.0888416 -1076.7281 -1067.6392 - 36400 3.64 0.07645861 1130.6907 282.23737 -15.584507 9.0840287 -1076.7233 -1067.6392 - 36450 3.645 0.076458646 1150.3415 282.27709 -15.560741 9.0853074 -1076.7245 -1067.6392 - 36500 3.65 0.076458621 1161.8202 282.18974 -15.546059 9.0824956 -1076.7217 -1067.6392 - 36550 3.655 0.076458506 1140.503 282.57893 -15.5606 9.0950221 -1076.7343 -1067.6392 - 36600 3.66 0.07645853 1126.9511 283.97898 -15.602756 9.1400839 -1076.7793 -1067.6392 - 36650 3.665 0.076458682 1117.8456 286.05487 -15.646548 9.2068979 -1076.8461 -1067.6392 - 36700 3.67 0.076458755 1118.3433 288.56573 -15.675811 9.2877121 -1076.9269 -1067.6392 - 36750 3.675 0.076458745 1135.4181 291.29108 -15.685173 9.3754294 -1077.0147 -1067.6392 - 36800 3.68 0.076458756 1121.3092 293.8519 -15.677476 9.4578516 -1077.0971 -1067.6392 - 36850 3.685 0.076458796 1089.7128 296.34944 -15.680319 9.5382369 -1077.1775 -1067.6392 - 36900 3.69 0.076458813 1078.8527 298.59269 -15.709588 9.6104374 -1077.2497 -1067.6392 - 36950 3.695 0.076458823 1068.4725 300.08588 -15.752456 9.6584969 -1077.2977 -1067.6392 - 37000 3.7 0.07645894 1065.6302 300.97074 -15.794642 9.6869768 -1077.3262 -1067.6392 - 37050 3.705 0.076458928 1060.1083 301.92719 -15.834491 9.7177609 -1077.357 -1067.6392 - 37100 3.71 0.076458812 1062.0442 303.02051 -15.872538 9.7529504 -1077.3922 -1067.6392 - 37150 3.715 0.076458776 1077.0906 303.12539 -15.902945 9.756326 -1077.3956 -1067.6392 - 37200 3.72 0.076458783 1094.3589 300.82035 -15.918455 9.6821365 -1077.3214 -1067.6392 - 37250 3.725 0.076458796 1106.983 295.78025 -15.917907 9.519917 -1077.1592 -1067.6392 - 37300 3.73 0.0764587 1117.8928 288.74175 -15.902363 9.2933774 -1076.9326 -1067.6392 - 37350 3.735 0.076458595 1115.003 281.03285 -15.877976 9.0452603 -1076.6845 -1067.6392 - 37400 3.74 0.076458589 1067.6392 274.76086 -15.863011 8.8433914 -1076.4826 -1067.6392 - 37450 3.745 0.076458768 1025.0964 271.80953 -15.86958 8.7484006 -1076.3876 -1067.6392 - 37500 3.75 0.076458888 1008.1779 272.35831 -15.896126 8.7660636 -1076.4053 -1067.6392 - 37550 3.755 0.076458753 1006.7337 275.07578 -15.933997 8.8535276 -1076.4928 -1067.6392 - 37600 3.76 0.07645857 1015.7845 279.29514 -15.983502 8.9893309 -1076.6286 -1067.6392 - 37650 3.765 0.076458646 1037.2238 285.21821 -16.044625 9.1799695 -1076.8192 -1067.6392 - 37700 3.77 0.076458804 1064.362 291.89353 -16.093253 9.3948198 -1077.0341 -1067.6392 - 37750 3.775 0.076458938 1093.2339 297.54927 -16.113154 9.5768541 -1077.2161 -1067.6392 - 37800 3.78 0.076459003 1111.3525 301.09404 -16.115824 9.6909453 -1077.3302 -1067.6392 - 37850 3.785 0.076458993 1106.8732 302.49314 -16.121107 9.7359763 -1077.3752 -1067.6392 - 37900 3.79 0.076458927 1063.9114 302.20192 -16.138918 9.7266034 -1077.3658 -1067.6392 - 37950 3.795 0.076458914 1026.1339 300.74509 -16.166089 9.679714 -1077.3189 -1067.6392 - 38000 3.8 0.076458899 1031.7602 298.64261 -16.19177 9.6120443 -1077.2513 -1067.6392 - 38050 3.805 0.076458867 1069.7247 296.45336 -16.206246 9.5415814 -1077.1808 -1067.6392 - 38100 3.81 0.076458911 1107.4666 295.0445 -16.217521 9.4962363 -1077.1355 -1067.6392 - 38150 3.815 0.076458901 1131.7783 294.91865 -16.235949 9.4921858 -1077.1314 -1067.6392 - 38200 3.82 0.076458864 1148.5656 295.74562 -16.253565 9.5188023 -1077.158 -1067.6392 - 38250 3.825 0.076458822 1148.7391 297.07753 -16.259815 9.5616709 -1077.2009 -1067.6392 - 38300 3.83 0.076458755 1156.7033 299.00407 -16.260728 9.623678 -1077.2629 -1067.6392 - 38350 3.835 0.076458804 1159.1829 301.28024 -16.263754 9.6969383 -1077.3362 -1067.6392 - 38400 3.84 0.076458983 1147.0294 302.84565 -16.273506 9.7473221 -1077.3866 -1067.6392 - 38450 3.845 0.076458991 1136.4112 302.27164 -16.282019 9.7288474 -1077.3681 -1067.6392 - 38500 3.85 0.07645888 1113.9868 298.97061 -16.274402 9.6226012 -1077.2618 -1067.6392 - 38550 3.855 0.076458691 1101.738 294.06527 -16.251341 9.464719 -1077.104 -1067.6392 - 38600 3.86 0.076458665 1085.4951 289.46444 -16.218831 9.3166378 -1076.9559 -1067.6392 - 38650 3.865 0.07645876 1061.2109 287.27235 -16.190308 9.2460835 -1076.8853 -1067.6392 - 38700 3.87 0.076458765 1055.773 288.81749 -16.176864 9.2958149 -1076.935 -1067.6392 - 38750 3.875 0.076458766 1051.082 293.80099 -16.177139 9.4562127 -1077.0954 -1067.6392 - 38800 3.88 0.076458791 1034.9231 300.50343 -16.186889 9.6719362 -1077.3112 -1067.6392 - 38850 3.885 0.076458765 1027.5343 306.11666 -16.197928 9.8526023 -1077.4918 -1067.6392 - 38900 3.89 0.076458838 1018.2888 308.22875 -16.207065 9.9205815 -1077.5598 -1067.6392 - 38950 3.895 0.076458884 1014.4073 306.63445 -16.226798 9.8692679 -1077.5085 -1067.6392 - 39000 3.9 0.076458788 1003.5264 302.69876 -16.256287 9.7425945 -1077.3818 -1067.6392 - 39050 3.905 0.076458731 996.07885 298.3808 -16.280659 9.6036175 -1077.2428 -1067.6392 - 39100 3.91 0.076458769 1027.0513 295.40443 -16.293344 9.5078209 -1077.1471 -1067.6392 - 39150 3.915 0.076458854 1072.3569 294.24208 -16.298011 9.4704097 -1077.1096 -1067.6392 - 39200 3.92 0.07645888 1080.7481 294.38216 -16.312666 9.4749184 -1077.1142 -1067.6392 - 39250 3.925 0.076458798 1074.2137 294.25738 -16.34058 9.4709023 -1077.1101 -1067.6392 - 39300 3.93 0.076458746 1072.9308 292.45791 -16.371754 9.4129849 -1077.0522 -1067.6392 - 39350 3.935 0.076458686 1052.258 289.46155 -16.40727 9.3165447 -1076.9558 -1067.6392 - 39400 3.94 0.076458677 1011.4712 286.99005 -16.441308 9.2369974 -1076.8762 -1067.6392 - 39450 3.945 0.076458657 968.89107 287.00247 -16.46678 9.2373973 -1076.8766 -1067.6392 - 39500 3.95 0.076458611 967.37752 290.38424 -16.48508 9.346242 -1076.9855 -1067.6392 - 39550 3.955 0.076458569 982.34862 295.78407 -16.492955 9.5200397 -1077.1593 -1067.6392 - 39600 3.96 0.076458595 978.6948 301.01012 -16.490336 9.6882442 -1077.3275 -1067.6392 - 39650 3.965 0.076458753 981.93177 304.90328 -16.481839 9.8135487 -1077.4528 -1067.6392 - 39700 3.97 0.076458768 1019.382 308.08081 -16.477585 9.9158201 -1077.5551 -1067.6392 - 39750 3.975 0.076458612 1051.8152 311.88767 -16.490813 10.038347 -1077.6776 -1067.6392 - 39800 3.98 0.076458521 1042.8378 316.19618 -16.511509 10.177019 -1077.8163 -1067.6392 - 39850 3.985 0.076458483 1001.149 319.35878 -16.519321 10.27881 -1077.918 -1067.6392 - 39900 3.99 0.076458542 973.4915 319.4656 -16.514459 10.282248 -1077.9215 -1067.6392 - 39950 3.995 0.076458719 972.67572 315.26025 -16.50944 10.146896 -1077.7861 -1067.6392 - 40000 4 0.076458687 994.49843 307.54177 -16.514066 9.8984707 -1077.5377 -1067.6392 - 40050 4.005 0.076458609 1020.1483 299.32861 -16.525567 9.6341236 -1077.2734 -1067.6392 - 40100 4.01 0.076458534 1028.6046 293.95707 -16.536961 9.4612366 -1077.1005 -1067.6392 - 40150 4.015 0.076458539 1021.124 292.82994 -16.54357 9.424959 -1077.0642 -1067.6392 - 40200 4.02 0.076458617 1003.8564 295.01881 -16.539479 9.4954094 -1077.1346 -1067.6392 - 40250 4.025 0.076458708 1006.3834 298.32236 -16.525081 9.6017365 -1077.241 -1067.6392 - 40300 4.03 0.076458753 1049.8514 300.72691 -16.515775 9.6791289 -1077.3184 -1067.6392 - 40350 4.035 0.076458712 1095.1887 301.23959 -16.528202 9.6956299 -1077.3349 -1067.6392 - 40400 4.04 0.07645859 1095.7277 299.27704 -16.553461 9.6324637 -1077.2717 -1067.6392 - 40450 4.045 0.076458512 1074.8132 294.7824 -16.567973 9.4878003 -1077.127 -1067.6392 - 40500 4.05 0.076458607 1054.9582 288.94001 -16.563212 9.2997586 -1076.939 -1067.6392 - 40550 4.055 0.076458679 1033.1657 283.78395 -16.555924 9.1338066 -1076.773 -1067.6392 - 40600 4.06 0.07645866 1029.0046 281.14635 -16.566778 9.0489136 -1076.6881 -1067.6392 - 40650 4.065 0.076458604 1026.6036 282.2669 -16.593805 9.0849793 -1076.7242 -1067.6392 - 40700 4.07 0.076458581 1024.2464 287.64133 -16.619273 9.2579595 -1076.8972 -1067.6392 - 40750 4.075 0.076458663 1014.2573 296.48178 -16.635414 9.5424961 -1077.1817 -1067.6392 - 40800 4.08 0.076458634 1003.9119 306.29768 -16.644226 9.8584286 -1077.4977 -1067.6392 - 40850 4.085 0.076458596 997.14687 313.7758 -16.644922 10.099118 -1077.7384 -1067.6392 - 40900 4.09 0.076458698 1003.6464 316.62645 -16.638874 10.190868 -1077.8301 -1067.6392 - 40950 4.095 0.076458737 1009.5074 314.15339 -16.626746 10.111271 -1077.7505 -1067.6392 - 41000 4.1 0.076458626 990.49508 306.88333 -16.607056 9.877278 -1077.5165 -1067.6392 - 41050 4.105 0.076458539 1003.9156 296.82556 -16.581033 9.5535609 -1077.1928 -1067.6392 - 41100 4.11 0.076458624 1025.7889 287.94279 -16.555411 9.2676623 -1076.9069 -1067.6392 - 41150 4.115 0.076458727 1019.8472 284.75687 -16.545411 9.1651209 -1076.8043 -1067.6392 - 41200 4.12 0.076458658 1009.1747 288.8934 -16.556045 9.2982584 -1076.9375 -1067.6392 - 41250 4.125 0.076458476 986.14702 297.74613 -16.573101 9.5831902 -1077.2224 -1067.6392 - 41300 4.13 0.076458533 970.56183 307.17123 -16.586828 9.8865443 -1077.5258 -1067.6392 - 41350 4.135 0.076458666 982.32883 313.98696 -16.593184 10.105914 -1077.7451 -1067.6392 - 41400 4.14 0.076458558 998.00634 316.68471 -16.585096 10.192743 -1077.832 -1067.6392 - 41450 4.145 0.076458375 988.08432 315.93321 -16.578349 10.168555 -1077.8078 -1067.6392 - 41500 4.15 0.076458387 968.13272 312.86745 -16.587207 10.069882 -1077.7091 -1067.6392 - 41550 4.155 0.07645851 962.22331 308.01319 -16.60083 9.9136436 -1077.5529 -1067.6392 - 41600 4.16 0.076458592 977.28521 302.567 -16.60995 9.7383536 -1077.3776 -1067.6392 - 41650 4.165 0.076458508 989.72477 297.98726 -16.609001 9.5909514 -1077.2302 -1067.6392 - 41700 4.17 0.076458343 1002.0807 295.07216 -16.600686 9.4971264 -1077.1364 -1067.6392 - 41750 4.175 0.076458382 1016.3945 293.91041 -16.584772 9.4597347 -1077.099 -1067.6392 - 41800 4.18 0.076458495 1009.6321 295.39416 -16.566658 9.5074902 -1077.1467 -1067.6392 - 41850 4.185 0.076458517 981.99051 300.65179 -16.561637 9.6767113 -1077.3159 -1067.6392 - 41900 4.19 0.076458508 963.70095 308.76413 -16.575186 9.9378133 -1077.577 -1067.6392 - 41950 4.195 0.07645848 934.77452 316.95219 -16.596303 10.201352 -1077.8406 -1067.6392 - 42000 4.2 0.076458508 904.42332 322.22055 -16.611182 10.370919 -1078.0102 -1067.6392 - 42050 4.205 0.07645857 902.29913 322.33865 -16.615342 10.37472 -1078.014 -1067.6392 - 42100 4.21 0.076458573 919.95355 316.51673 -16.615481 10.187337 -1077.8266 -1067.6392 - 42150 4.215 0.076458639 929.08587 305.64828 -16.617453 9.8375273 -1077.4768 -1067.6392 - 42200 4.22 0.076458638 921.14374 292.41301 -16.622157 9.4115396 -1077.0508 -1067.6392 - 42250 4.225 0.076458624 918.70221 281.1294 -16.634159 9.0483679 -1076.6876 -1067.6392 - 42300 4.23 0.076458699 936.43193 275.83201 -16.6517 8.8778674 -1076.5171 -1067.6392 - 42350 4.235 0.07645883 969.33399 278.31739 -16.669195 8.9578611 -1076.5971 -1067.6392 - 42400 4.24 0.076458843 1009.9309 287.35916 -16.679204 9.2488775 -1076.8881 -1067.6392 - 42450 4.245 0.07645864 1036.0019 299.66752 -16.672063 9.6450318 -1077.2843 -1067.6392 - 42500 4.25 0.076458571 1027.6855 312.04895 -16.657188 10.043538 -1077.6828 -1067.6392 - 42550 4.255 0.076458623 1015.0072 322.01276 -16.654314 10.364231 -1078.0035 -1067.6392 - 42600 4.26 0.076458688 1013.2933 327.27486 -16.660339 10.533595 -1078.1728 -1067.6392 - 42650 4.265 0.076458817 1018.1646 326.73267 -16.660439 10.516145 -1078.1554 -1067.6392 - 42700 4.27 0.076458894 1010.1919 321.82992 -16.65551 10.358346 -1077.9976 -1067.6392 - 42750 4.275 0.076458864 1005.0687 315.35709 -16.653726 10.150013 -1077.7892 -1067.6392 - 42800 4.28 0.076458884 1010.6833 308.9802 -16.655199 9.9447675 -1077.584 -1067.6392 - 42850 4.285 0.076458814 1016.6151 303.05879 -16.657304 9.7541825 -1077.3934 -1067.6392 - 42900 4.29 0.076458713 1017.0053 298.08717 -16.662548 9.5941669 -1077.2334 -1067.6392 - 42950 4.295 0.076458716 1044.7957 294.65223 -16.669187 9.4836106 -1077.1228 -1067.6392 - 43000 4.3 0.076458705 1100.4358 292.80033 -16.665407 9.4240058 -1077.0632 -1067.6392 - 43050 4.305 0.076458683 1131.0739 293.34724 -16.656462 9.4416087 -1077.0808 -1067.6392 - 43100 4.31 0.076458605 1142.3657 296.86691 -16.653769 9.554892 -1077.1941 -1067.6392 - 43150 4.315 0.076458599 1142.8044 301.19681 -16.655832 9.694253 -1077.3335 -1067.6392 - 43200 4.32 0.076458671 1131.7209 302.63924 -16.652234 9.7406789 -1077.3799 -1067.6392 - 43250 4.325 0.07645862 1107.868 299.38237 -16.640553 9.6358538 -1077.2751 -1067.6392 - 43300 4.33 0.076458564 1086.9877 293.0869 -16.632969 9.4332293 -1077.0725 -1067.6392 - 43350 4.335 0.076458694 1085.9393 287.23945 -16.637169 9.2450247 -1076.8843 -1067.6392 - 43400 4.34 0.076458728 1084.4536 284.62782 -16.651022 9.1609673 -1076.8002 -1067.6392 - 43450 4.345 0.076458737 1071.0304 286.42024 -16.664054 9.2186576 -1076.8579 -1067.6392 - 43500 4.35 0.07645867 1071.4218 292.14965 -16.663945 9.4030633 -1077.0423 -1067.6392 - 43550 4.355 0.076458545 1058.5175 299.7894 -16.651551 9.6489546 -1077.2882 -1067.6392 - 43600 4.36 0.076458522 1017.0691 307.34199 -16.653799 9.8920404 -1077.5313 -1067.6392 - 43650 4.365 0.07645853 984.06733 313.34684 -16.684092 10.085311 -1077.7245 -1067.6392 - 43700 4.37 0.076458526 972.47105 317.13488 -16.726591 10.207232 -1077.8465 -1067.6392 - 43750 4.375 0.076458563 982.95807 319.12477 -16.764918 10.271278 -1077.9105 -1067.6392 - 43800 4.38 0.076458569 1000.5706 319.98217 -16.791105 10.298874 -1077.9381 -1067.6392 - 43850 4.385 0.076458604 1012.6091 319.95908 -16.796106 10.298131 -1077.9374 -1067.6392 - 43900 4.39 0.076458647 1016.6021 319.07693 -16.782232 10.269739 -1077.909 -1067.6392 - 43950 4.395 0.076458717 1039.7933 317.11992 -16.765953 10.206751 -1077.846 -1067.6392 - 44000 4.4 0.07645855 1076.1914 313.94493 -16.75837 10.104561 -1077.7438 -1067.6392 - 44050 4.405 0.076458354 1103.7125 309.85364 -16.755308 9.9728798 -1077.6121 -1067.6392 - 44100 4.41 0.076458497 1123.4426 305.92806 -16.754699 9.8465319 -1077.4858 -1067.6392 - 44150 4.415 0.076458707 1128.503 303.80427 -16.759223 9.7781762 -1077.4174 -1067.6392 - 44200 4.42 0.07645872 1109.8757 305.14407 -16.773282 9.8212987 -1077.4605 -1067.6392 - 44250 4.425 0.076458604 1077.7556 310.10841 -16.799981 9.9810798 -1077.6203 -1067.6392 - 44300 4.43 0.076458461 1058.8761 316.28846 -16.829881 10.17999 -1077.8192 -1067.6392 - 44350 4.435 0.076458508 1050.5707 320.51508 -16.852668 10.316027 -1077.9553 -1067.6392 - 44400 4.44 0.076458673 1056.8449 320.97804 -16.866357 10.330927 -1077.9702 -1067.6392 - 44450 4.445 0.076458651 1050.8827 318.14487 -16.875492 10.239739 -1077.879 -1067.6392 - 44500 4.45 0.076458481 1013.764 314.16723 -16.897045 10.111716 -1077.7509 -1067.6392 - 44550 4.455 0.076458392 980.5404 310.15036 -16.935928 9.9824299 -1077.6217 -1067.6392 - 44600 4.46 0.076458504 982.46196 305.57929 -16.974614 9.8353065 -1077.4745 -1067.6392 - 44650 4.465 0.076458584 999.3409 300.38563 -17.000466 9.6681446 -1077.3074 -1067.6392 - 44700 4.47 0.076458532 1009.2469 295.28724 -17.008 9.5040491 -1077.1433 -1067.6392 - 44750 4.475 0.076458496 1041.4242 291.50055 -17.008549 9.3821713 -1077.0214 -1067.6392 - 44800 4.48 0.076458487 1086.602 289.52839 -17.016148 9.3186959 -1076.9579 -1067.6392 - 44850 4.485 0.076458613 1103.5806 288.55396 -17.029368 9.287333 -1076.9266 -1067.6392 - 44900 4.49 0.07645858 1102.8142 287.89912 -17.042093 9.2662566 -1076.9055 -1067.6392 - 44950 4.495 0.07645852 1106.0548 288.11976 -17.050281 9.273358 -1076.9126 -1067.6392 - 45000 4.5 0.076458412 1109.2471 290.73864 -17.064227 9.3576488 -1076.9969 -1067.6392 - 45050 4.505 0.076458467 1081.3367 296.40828 -17.091233 9.5401305 -1077.1794 -1067.6392 - 45100 4.51 0.076458612 1061.7915 304.1106 -17.120168 9.7880355 -1077.4273 -1067.6392 - 45150 4.515 0.076458508 1075.8664 312.21278 -17.139278 10.048811 -1077.688 -1067.6392 - 45200 4.52 0.076458381 1086.9758 319.4826 -17.149932 10.282795 -1077.922 -1067.6392 - 45250 4.525 0.076458463 1081.4821 325.45586 -17.161699 10.47505 -1078.1143 -1067.6392 - 45300 4.53 0.076458584 1102.657 330.33928 -17.184503 10.632226 -1078.2715 -1067.6392 - 45350 4.535 0.076458507 1115.9422 333.72518 -17.208225 10.741204 -1078.3804 -1067.6392 - 45400 4.54 0.076458398 1094.6076 334.77591 -17.228637 10.775023 -1078.4143 -1067.6392 - 45450 4.545 0.076458455 1089.9234 332.91387 -17.252893 10.715091 -1078.3543 -1067.6392 - 45500 4.55 0.076458651 1088.2901 328.25855 -17.279739 10.565256 -1078.2045 -1067.6392 - 45550 4.555 0.076458679 1067.4543 322.55465 -17.319717 10.381672 -1078.0209 -1067.6392 - 45600 4.56 0.076458491 1051.2478 317.7723 -17.374362 10.227748 -1077.867 -1067.6392 - 45650 4.565 0.076458315 1034.4257 314.73532 -17.430482 10.130001 -1077.7692 -1067.6392 - 45700 4.57 0.076458379 1013.128 312.65325 -17.476583 10.062987 -1077.7022 -1067.6392 - 45750 4.575 0.076458582 1006.4499 309.50085 -17.496142 9.9615252 -1077.6008 -1067.6392 - 45800 4.58 0.07645865 1024.4651 304.73909 -17.49261 9.8082641 -1077.4475 -1067.6392 - 45850 4.585 0.076458631 1046.9622 300.08416 -17.492695 9.6584417 -1077.2977 -1067.6392 - 45900 4.59 0.076458586 1042.5796 296.72782 -17.49113 9.5504152 -1077.1896 -1067.6392 - 45950 4.595 0.076458607 1008.0854 295.42286 -17.47404 9.508414 -1077.1476 -1067.6392 - 46000 4.6 0.07645866 1008.1817 297.6509 -17.457674 9.5801252 -1077.2194 -1067.6392 - 46050 4.605 0.076458648 1055.0177 303.82712 -17.454258 9.7789116 -1077.4181 -1067.6392 - 46100 4.61 0.076458681 1067.8096 312.06106 -17.459314 10.043927 -1077.6832 -1067.6392 - 46150 4.615 0.076458697 1032.3327 319.35809 -17.472054 10.278788 -1077.918 -1067.6392 - 46200 4.62 0.076458669 1011.4049 323.68987 -17.497176 10.41821 -1078.0574 -1067.6392 - 46250 4.625 0.076458694 1013.1694 324.55935 -17.524643 10.446195 -1078.0854 -1067.6392 - 46300 4.63 0.076458699 1019.9594 322.92316 -17.537516 10.393533 -1078.0328 -1067.6392 - 46350 4.635 0.076458638 1019.574 321.37933 -17.53535 10.343843 -1077.9831 -1067.6392 - 46400 4.64 0.076458549 1012.1208 322.2852 -17.529784 10.372999 -1078.0122 -1067.6392 - 46450 4.645 0.076458548 1009.7285 324.98438 -17.51749 10.459874 -1078.0991 -1067.6392 - 46500 4.65 0.076458739 1028.6359 327.73895 -17.495382 10.548533 -1078.1878 -1067.6392 - 46550 4.655 0.076458848 1054.5382 329.99374 -17.486615 10.621105 -1078.2603 -1067.6392 - 46600 4.66 0.076458871 1059.0432 330.41234 -17.496838 10.634578 -1078.2738 -1067.6392 - 46650 4.665 0.076458903 1042.6963 327.41225 -17.503279 10.538018 -1078.1773 -1067.6392 - 46700 4.67 0.076458964 1022.4908 322.64011 -17.50695 10.384422 -1078.0237 -1067.6392 - 46750 4.675 0.076458954 994.76603 319.77739 -17.52877 10.292284 -1077.9315 -1067.6392 - 46800 4.68 0.076458851 984.77354 320.04823 -17.564766 10.301001 -1077.9402 -1067.6392 - 46850 4.685 0.076458817 982.80807 322.12061 -17.59199 10.367702 -1078.0069 -1067.6392 - 46900 4.69 0.076458814 979.08705 324.60632 -17.607769 10.447706 -1078.0869 -1067.6392 - 46950 4.695 0.076458855 991.35981 325.87675 -17.625638 10.488596 -1078.1278 -1067.6392 - 47000 4.7 0.076459013 990.03823 324.25249 -17.644352 10.436318 -1078.0756 -1067.6392 - 47050 4.705 0.076459109 971.57257 320.13246 -17.664176 10.303712 -1077.9429 -1067.6392 - 47100 4.71 0.076459008 942.51677 315.82868 -17.695488 10.165191 -1077.8044 -1067.6392 - 47150 4.715 0.076458834 914.38458 312.92259 -17.729828 10.071656 -1077.7109 -1067.6392 - 47200 4.72 0.076458733 915.09427 311.73756 -17.757168 10.033515 -1077.6727 -1067.6392 - 47250 4.725 0.076458745 929.51292 311.72739 -17.778102 10.033188 -1077.6724 -1067.6392 - 47300 4.73 0.076458807 924.69906 311.5334 -17.787073 10.026944 -1077.6662 -1067.6392 - 47350 4.735 0.076458753 911.78727 310.21898 -17.784392 9.9846387 -1077.6239 -1067.6392 - 47400 4.74 0.076458811 927.84413 308.28881 -17.783399 9.9225147 -1077.5617 -1067.6392 - 47450 4.745 0.076458948 980.47197 307.41202 -17.799967 9.8942944 -1077.5335 -1067.6392 - 47500 4.75 0.076458921 1017.4095 308.92974 -17.837931 9.9431434 -1077.5824 -1067.6392 - 47550 4.755 0.076458813 1013.2842 313.10487 -17.889197 10.077523 -1077.7168 -1067.6392 - 47600 4.76 0.076458768 999.59926 319.59121 -17.94301 10.286291 -1077.9255 -1067.6392 - 47650 4.765 0.07645894 987.28899 327.28821 -17.990152 10.534025 -1078.1733 -1067.6392 - 47700 4.77 0.076459039 970.5822 333.98868 -18.025704 10.749685 -1078.3889 -1067.6392 - 47750 4.775 0.076458976 960.77569 337.1295 -18.039516 10.850774 -1078.49 -1067.6392 - 47800 4.78 0.076458945 970.90315 335.79522 -18.031317 10.80783 -1078.4471 -1067.6392 - 47850 4.785 0.07645907 982.20263 331.08028 -18.021902 10.656076 -1078.2953 -1067.6392 - 47900 4.79 0.076459119 990.67784 324.66683 -18.027289 10.449654 -1078.0889 -1067.6392 - 47950 4.795 0.076459083 998.43821 318.73987 -18.04994 10.25889 -1077.8981 -1067.6392 - 48000 4.8 0.076459069 1008.9151 315.53792 -18.077243 10.155833 -1077.7951 -1067.6392 - 48050 4.805 0.076458972 1028.1309 316.51509 -18.096678 10.187284 -1077.8265 -1067.6392 - 48100 4.81 0.076458972 1046.4248 321.4715 -18.10541 10.34681 -1077.986 -1067.6392 - 48150 4.815 0.076458847 1072.5091 328.3071 -18.108273 10.566819 -1078.2061 -1067.6392 - 48200 4.82 0.076458729 1115.3266 334.27433 -18.108253 10.758879 -1078.3981 -1067.6392 - 48250 4.825 0.076458863 1132.7705 338.0335 -18.108395 10.879871 -1078.5191 -1067.6392 - 48300 4.83 0.076458983 1104.4857 340.31669 -18.122648 10.953357 -1078.5926 -1067.6392 - 48350 4.835 0.076458942 1068.6895 341.52058 -18.147861 10.992105 -1078.6313 -1067.6392 - 48400 4.84 0.076458895 1050.2826 340.59905 -18.165876 10.962445 -1078.6017 -1067.6392 - 48450 4.845 0.076458979 1048.172 336.60118 -18.175839 10.83377 -1078.473 -1067.6392 - 48500 4.85 0.076458957 1026.5586 330.00847 -18.186406 10.621579 -1078.2608 -1067.6392 - 48550 4.855 0.076458886 999.91162 322.83938 -18.201023 10.390836 -1078.0301 -1067.6392 - 48600 4.86 0.076458961 989.90718 317.46387 -18.226455 10.217821 -1077.8571 -1067.6392 - 48650 4.865 0.076459015 982.96635 315.18649 -18.260376 10.144522 -1077.7838 -1067.6392 - 48700 4.87 0.076458922 987.30339 316.51586 -18.291398 10.187309 -1077.8265 -1067.6392 - 48750 4.875 0.076458754 1001.7173 321.20925 -18.314994 10.338369 -1077.9776 -1067.6392 - 48800 4.88 0.07645878 1018.8788 327.87563 -18.327226 10.552932 -1078.1922 -1067.6392 - 48850 4.885 0.076458771 1034.4957 334.62729 -18.332453 10.770239 -1078.4095 -1067.6392 - 48900 4.89 0.076458899 1028.6393 339.07218 -18.341739 10.913301 -1078.5525 -1067.6392 - 48950 4.895 0.076459103 1007.6856 338.61189 -18.356096 10.898487 -1078.5377 -1067.6392 - 49000 4.9 0.076459192 999.24745 332.23323 -18.365334 10.693184 -1078.3324 -1067.6392 - 49050 4.905 0.076459086 996.76706 322.52584 -18.367263 10.380744 -1078.02 -1067.6392 - 49100 4.91 0.076459029 995.85019 315.08451 -18.370824 10.14124 -1077.7805 -1067.6392 - 49150 4.915 0.076459032 983.16555 314.29119 -18.382926 10.115706 -1077.7549 -1067.6392 - 49200 4.92 0.076459075 965.8709 319.65382 -18.396231 10.288306 -1077.9275 -1067.6392 - 49250 4.925 0.076459124 962.09918 328.07092 -18.405747 10.559217 -1078.1984 -1067.6392 - 49300 4.93 0.076459019 986.327 337.01122 -18.409264 10.846968 -1078.4862 -1067.6392 - 49350 4.935 0.076458927 1004.57 345.36436 -18.407413 11.11582 -1078.7551 -1067.6392 - 49400 4.94 0.076458977 993.98483 352.63606 -18.40944 11.349865 -1078.9891 -1067.6392 - 49450 4.945 0.076459082 991.26185 357.60801 -18.416364 11.509891 -1079.1491 -1067.6392 - 49500 4.95 0.076459093 1024.0819 359.05103 -18.425791 11.556336 -1079.1956 -1067.6392 - 49550 4.955 0.076458927 1033.8368 356.67554 -18.441932 11.479879 -1079.1191 -1067.6392 - 49600 4.96 0.076458838 1019.5756 350.49667 -18.455292 11.281007 -1078.9202 -1067.6392 - 49650 4.965 0.076458925 1015.2811 341.2581 -18.44834 10.983657 -1078.6229 -1067.6392 - 49700 4.97 0.076458904 1000.5326 331.64361 -18.423481 10.674207 -1078.3134 -1067.6392 - 49750 4.975 0.076458763 997.47426 325.30523 -18.400499 10.470201 -1078.1094 -1067.6392 - 49800 4.98 0.076458774 1001.6165 323.8013 -18.387438 10.421796 -1078.061 -1067.6392 - 49850 4.985 0.076458923 1003.6919 325.43465 -18.371483 10.474367 -1078.1136 -1067.6392 - 49900 4.99 0.076458997 1014.0371 327.90126 -18.352198 10.553757 -1078.193 -1067.6392 - 49950 4.995 0.076458983 1024.0345 329.92754 -18.340929 10.618974 -1078.2582 -1067.6392 - 50000 5 0.076458894 1024.5951 330.62163 -18.327421 10.641314 -1078.2805 -1067.6392 -Loop time of 104.807 on 4 procs for 50000 steps with 250 atoms - -Performance: 4.122 ns/day, 5.823 hours/ns, 477.068 timesteps/s -98.2% CPU use with 4 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 16.436 | 16.633 | 16.862 | 4.5 | 15.87 -Neigh | 0.16699 | 0.17008 | 0.17166 | 0.4 | 0.16 -Comm | 4.1416 | 4.3331 | 4.5047 | 7.9 | 4.13 -Output | 10.767 | 11.845 | 12.706 | 20.7 | 11.30 -Modify | 70.815 | 71.648 | 72.683 | 8.2 | 68.36 -Other | | 0.1775 | | | 0.17 - -Nlocal: 62.5 ave 65 max 60 min -Histogram: 1 0 0 0 1 0 1 0 0 1 -Nghost: 757.75 ave 776 max 743 min -Histogram: 1 0 0 1 1 0 0 0 0 1 -Neighs: 1932.75 ave 2015 max 1844 min -Histogram: 1 0 0 0 1 1 0 0 0 1 -FullNghs: 3865.5 ave 4024 max 3710 min -Histogram: 1 0 0 1 0 0 1 0 0 1 - -Total # of neighbors = 15462 -Ave neighs/atom = 61.848 -Neighbor list builds = 612 -Dangerous builds = 0 - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:01:45 diff --git a/examples/SPIN/nickel/in.spin.nickel b/examples/SPIN/nickel/in.spin.nickel index 7096fda960..1d62188d8f 100644 --- a/examples/SPIN/nickel/in.spin.nickel +++ b/examples/SPIN/nickel/in.spin.nickel @@ -1,58 +1,57 @@ # fcc nickel in a 3d periodic box clear -units metal -atom_style spin +units metal +atom_style spin -dimension 3 -boundary p p p +dimension 3 +boundary p p p # necessary for the serial algorithm (sametag) -atom_modify map array +atom_modify map array -lattice fcc 3.524 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -create_atoms 1 box +lattice fcc 3.524 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +create_atoms 1 box # setting mass, mag. moments, and interactions for cobalt -mass 1 58.69 +mass 1 58.69 -set group all spin/random 31 0.63 -#set group all spin 0.63 0.0 0.0 1.0 -velocity all create 100 4928459 rot yes dist gaussian +set group all spin/random 31 0.63 +#set group all spin 0.63 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Ni99.eam.alloy Ni -pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Ni99.eam.alloy Ni +pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice moving -timestep 0.0001 +fix 3 all nve/spin lattice moving +timestep 0.0001 # compute and output options -compute out_mag all spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] thermo_style custom step time v_magnorm v_emag temp v_tmag etotal thermo 50 -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] - -run 2000 +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +run 1000 diff --git a/examples/SPIN/nickel/in.spin.nickel_cubic b/examples/SPIN/nickel/in.spin.nickel_cubic index 76ea23689a..1ae069a64f 100644 --- a/examples/SPIN/nickel/in.spin.nickel_cubic +++ b/examples/SPIN/nickel/in.spin.nickel_cubic @@ -54,7 +54,7 @@ thermo_style custom step time v_magnorm v_emag temp v_tmag etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -run 2000 +run 1000 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 new file mode 100644 index 0000000000..b73f7daad7 --- /dev/null +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.1 @@ -0,0 +1,136 @@ +LAMMPS (30 Oct 2019) +# fcc nickel in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice fcc 3.524 +Lattice spacing in x,y,z = 3.524 3.524 3.524 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.00070715 secs + +# setting mass, mag. moments, and interactions for cobalt + +mass 1 58.69 + +set group all spin/random 31 0.63 + 500 settings made for spin/random +#set group all spin 0.63 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Ni99.eam.alloy Ni +pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_emag temp v_tmag etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.90375 + ghost atom cutoff = 5.90375 + binsize = 2.95187, bins = 6 6 6 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.885 | 7.885 | 7.885 Mbytes +Step Time v_magnorm v_emag Temp v_tmag TotEng + 0 0 0.028733803 0.40997576 100.03408 -4775.0671 -2218.1018 + 50 0.005 0.028733807 0.070491717 101.47879 -28153.519 -2218.1018 + 100 0.01 0.028733815 -0.70937134 101.7311 2925.8177 -2218.1018 + 150 0.015 0.028733823 -1.853981 99.63039 1197.9339 -2218.1018 + 200 0.02 0.028733828 -3.2679239 94.850105 741.17431 -2218.1018 + 250 0.025 0.028733824 -4.863967 88.444584 550.36979 -2218.1018 + 300 0.03 0.028733807 -6.5763457 82.689581 449.78321 -2218.1018 + 350 0.035 0.028733783 -8.3489158 80.108798 384.32228 -2218.1018 + 400 0.04 0.028733763 -10.120216 82.374947 335.01545 -2218.1018 + 450 0.045 0.028733755 -11.828932 89.814597 296.88965 -2218.1018 + 500 0.05 0.028733762 -13.423712 101.39613 267.51686 -2218.1018 + 550 0.055 0.028733783 -14.866724 115.07399 244.96012 -2218.1018 + 600 0.06 0.028733801 -16.135279 128.57849 229.33327 -2218.1018 + 650 0.065 0.028733804 -17.222838 140.22402 220.05718 -2218.1018 + 700 0.07 0.028733795 -18.154813 149.61295 212.95678 -2218.1018 + 750 0.075 0.028733781 -18.996903 157.5814 206.41327 -2218.1018 + 800 0.08 0.028733768 -19.804249 164.92075 203.88977 -2218.1018 + 850 0.085 0.028733752 -20.579151 171.67278 203.42363 -2218.1018 + 900 0.09 0.028733728 -21.294277 177.67238 199.84817 -2218.1018 + 950 0.095 0.028733715 -21.943945 183.2621 194.9614 -2218.1018 + 1000 0.1 0.02873374 -22.551277 188.99284 191.59796 -2218.1018 +Loop time of 5.15676 on 1 procs for 1000 steps with 500 atoms + +Performance: 1.675 ns/day, 14.324 hours/ns, 193.920 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 | 2.4083 | 2.4083 | 2.4083 | 0.0 | 46.70 +Neigh | 0.016825 | 0.016825 | 0.016825 | 0.0 | 0.33 +Comm | 0.039891 | 0.039891 | 0.039891 | 0.0 | 0.77 +Output | 0.018168 | 0.018168 | 0.018168 | 0.0 | 0.35 +Modify | 2.6657 | 2.6657 | 2.6657 | 0.0 | 51.69 +Other | | 0.007864 | | | 0.15 + +Nlocal: 500 ave 500 max 500 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1956 ave 1956 max 1956 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Neighs: 19504 ave 19504 max 19504 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 39008 ave 39008 max 39008 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 39008 +Ave neighs/atom = 78.016 +Neighbor list builds = 9 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:05 diff --git a/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 new file mode 100644 index 0000000000..92bcc4f533 --- /dev/null +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel.g++.4 @@ -0,0 +1,136 @@ +LAMMPS (30 Oct 2019) +# fcc nickel in a 3d periodic box + +clear +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice fcc 3.524 +Lattice spacing in x,y,z = 3.524 3.524 3.524 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 500 atoms + create_atoms CPU = 0.00071907 secs + +# setting mass, mag. moments, and interactions for cobalt + +mass 1 58.69 + +set group all spin/random 31 0.63 + 500 settings made for spin/random +#set group all spin 0.63 0.0 0.0 1.0 +velocity all create 100 4928459 rot yes dist gaussian + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Ni99.eam.alloy Ni +pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# compute and output options + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo_style custom step time v_magnorm v_emag temp v_tmag etotal +thermo 50 + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +run 1000 +Neighbor list info ... + update every 10 steps, delay 20 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 5.90375 + ghost atom cutoff = 5.90375 + binsize = 2.95187, bins = 6 6 6 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 7.799 | 7.799 | 7.799 Mbytes +Step Time v_magnorm v_emag Temp v_tmag TotEng + 0 0 0.028733803 0.40997576 100.03408 -4775.0671 -2218.1018 + 50 0.005 0.028733805 0.25324083 98.741633 -7863.8744 -2218.1018 + 100 0.01 0.028733812 -0.37320751 97.073875 5622.1863 -2218.1018 + 150 0.015 0.028733819 -1.3971549 94.073447 1625.0258 -2218.1018 + 200 0.02 0.028733825 -2.7238372 89.419944 919.37601 -2218.1018 + 250 0.025 0.028733829 -4.2684428 84.07494 652.18375 -2218.1018 + 300 0.03 0.028733824 -5.9636712 80.06368 512.89077 -2218.1018 + 350 0.035 0.02873381 -7.7386326 79.366702 422.24864 -2218.1018 + 400 0.04 0.028733802 -9.5148059 83.052751 357.60379 -2218.1018 + 450 0.045 0.028733806 -11.234935 91.282747 310.87776 -2218.1018 + 500 0.05 0.02873381 -12.875184 103.49836 275.0224 -2218.1018 + 550 0.055 0.028733808 -14.413473 118.16526 247.85208 -2218.1018 + 600 0.06 0.028733803 -15.812466 132.83837 230.67903 -2218.1018 + 650 0.065 0.028733808 -17.061311 145.41049 222.19476 -2218.1018 + 700 0.07 0.028733818 -18.181903 154.83414 219.42933 -2218.1018 + 750 0.075 0.028733823 -19.176259 160.58645 218.45231 -2218.1018 + 800 0.08 0.028733825 -20.035157 163.02829 214.86596 -2218.1018 + 850 0.085 0.028733825 -20.806548 164.4197 209.86881 -2218.1018 + 900 0.09 0.028733829 -21.571419 167.8571 205.79849 -2218.1018 + 950 0.095 0.028733825 -22.365879 175.00875 201.33088 -2218.1018 + 1000 0.1 0.028733821 -23.133464 184.68305 195.52912 -2218.1018 +Loop time of 3.95668 on 4 procs for 1000 steps with 500 atoms + +Performance: 2.184 ns/day, 10.991 hours/ns, 252.737 timesteps/s +97.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.89404 | 0.99018 | 1.0827 | 8.5 | 25.03 +Neigh | 0.0050189 | 0.0053826 | 0.0057576 | 0.5 | 0.14 +Comm | 0.23366 | 0.32767 | 0.42737 | 15.2 | 8.28 +Output | 0.0078192 | 0.0078953 | 0.0080998 | 0.1 | 0.20 +Modify | 2.6171 | 2.6192 | 2.6219 | 0.1 | 66.20 +Other | | 0.006363 | | | 0.16 + +Nlocal: 125 ave 139 max 112 min +Histogram: 1 0 1 0 0 0 1 0 0 1 +Nghost: 1099 ave 1112 max 1085 min +Histogram: 1 0 0 1 0 0 0 1 0 1 +Neighs: 4876 ave 5386 max 4426 min +Histogram: 1 0 0 1 0 1 0 0 0 1 +FullNghs: 9752 ave 10845 max 8737 min +Histogram: 1 0 1 0 0 0 1 0 0 1 + +Total # of neighbors = 39008 +Ave neighs/atom = 78.016 +Neighbor list builds = 9 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:03 diff --git a/examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.1 b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 similarity index 54% rename from examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.1 rename to examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 index 425572dedf..2aa4a9a0d3 100644 --- a/examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.1 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.1 @@ -1,9 +1,7 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task +LAMMPS (30 Oct 2019) # fcc nickel in a 3d periodic box clear - using 1 OpenMP thread(s) per MPI task units metal atom_style spin @@ -21,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.00068903 secs + create_atoms CPU = 0.000488997 secs # setting mass, mag. moments, and interactions for cobalt @@ -43,7 +41,7 @@ fix 1 all precession/spin cubic -0.0001 0.0 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1. fix_modify 1 energy yes fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # compute and output options @@ -62,9 +60,9 @@ thermo_style custom step time v_magnorm v_emag temp v_tmag etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -run 2000 +run 1000 Neighbor list info ... update every 10 steps, delay 20 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -82,79 +80,59 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.384 | 7.384 | 7.384 Mbytes +Per MPI rank memory allocation (min/avg/max) = 7.885 | 7.885 | 7.885 Mbytes Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.455085 100.03408 -8603.706 -2218.0905 - 50 0.005 0.028732021 0.11535308 101.47887 -34407.888 -2218.0904 - 100 0.01 0.0287304 -0.665283 101.73105 6238.4535 -2218.09 - 150 0.015 0.028729403 -1.8105707 99.629794 2452.7607 -2218.0896 - 200 0.02 0.028731067 -3.224763 94.849715 1501.8625 -2218.0895 - 250 0.025 0.028732765 -4.8207784 88.447019 1110.3291 -2218.0895 - 300 0.03 0.028728169 -6.5331538 82.697813 905.2202 -2218.0896 - 350 0.035 0.02871707 -8.3059526 80.122838 772.40218 -2218.0896 - 400 0.04 0.028706605 -10.077613 82.389555 672.72236 -2218.0895 - 450 0.045 0.028701727 -11.78634 89.823176 595.82956 -2218.0894 - 500 0.05 0.028706691 -13.380919 101.39804 536.65866 -2218.0894 - 550 0.055 0.028714065 -14.824128 115.07511 491.25787 -2218.0893 - 600 0.06 0.028713691 -16.093505 128.58093 459.82107 -2218.089 - 650 0.065 0.028713232 -17.181217 140.22137 441.15183 -2218.089 - 700 0.07 0.02871245 -18.113035 149.60156 426.80154 -2218.0889 - 750 0.075 0.028712431 -18.954952 157.56849 413.61924 -2218.0891 - 800 0.08 0.02872489 -19.762756 164.91833 408.49483 -2218.0892 - 850 0.085 0.028733709 -20.538757 171.69348 407.47868 -2218.0894 - 900 0.09 0.028737031 -21.256095 177.71981 400.24086 -2218.0894 - 950 0.095 0.028743446 -21.908156 183.31613 390.46773 -2218.089 - 1000 0.1 0.028751809 -22.516179 189.01672 383.80802 -2218.0888 - 1050 0.105 0.028761625 -23.084057 194.48882 376.54433 -2218.089 - 1100 0.11 0.028768138 -23.565036 198.12295 366.13309 -2218.0891 - 1150 0.115 0.028770301 -23.937136 198.95102 354.82763 -2218.089 - 1200 0.12 0.028771334 -24.273509 198.31348 347.20512 -2218.0891 - 1250 0.125 0.028769662 -24.672789 198.26173 344.02095 -2218.0889 - 1300 0.13 0.028774175 -25.13917 199.48259 337.81596 -2218.0889 - 1350 0.135 0.028795936 -25.594094 201.33509 329.891 -2218.0889 - 1400 0.14 0.028824328 -25.978285 203.4984 328.81092 -2218.0886 - 1450 0.145 0.028846467 -26.299501 206.52931 328.61151 -2218.0886 - 1500 0.15 0.028858261 -26.605847 211.09044 324.29045 -2218.0888 - 1550 0.155 0.028852825 -26.92321 216.70656 317.24339 -2218.0888 - 1600 0.16 0.02885238 -27.232535 221.73117 312.50182 -2218.0888 - 1650 0.165 0.028857985 -27.513725 224.82466 312.32346 -2218.0887 - 1700 0.17 0.028863985 -27.764471 225.85697 312.80779 -2218.0887 - 1750 0.175 0.028868714 -27.983273 225.71411 315.37238 -2218.0888 - 1800 0.18 0.028871144 -28.187572 225.78979 319.44034 -2218.0888 - 1850 0.185 0.028865191 -28.395615 226.7477 321.25107 -2218.0889 - 1900 0.19 0.028855316 -28.597095 227.90237 319.98739 -2218.0889 - 1950 0.195 0.028853072 -28.79277 228.54008 313.04557 -2218.0886 - 2000 0.2 0.028855814 -29.015073 228.8643 300.40018 -2218.0885 -Loop time of 16.5858 on 1 procs for 2000 steps with 500 atoms + 0 0 0.028733803 0.455085 100.03408 -4301.853 -2218.0905 + 50 0.005 0.028732021 0.11535308 101.47887 -17203.944 -2218.0904 + 100 0.01 0.0287304 -0.665283 101.73105 3119.2267 -2218.09 + 150 0.015 0.028729403 -1.8105707 99.629794 1226.3803 -2218.0896 + 200 0.02 0.028731067 -3.224763 94.849715 750.93124 -2218.0895 + 250 0.025 0.028732765 -4.8207784 88.447019 555.16456 -2218.0895 + 300 0.03 0.028728169 -6.5331538 82.697813 452.6101 -2218.0896 + 350 0.035 0.02871707 -8.3059526 80.122838 386.20109 -2218.0896 + 400 0.04 0.028706605 -10.077613 82.389555 336.36118 -2218.0895 + 450 0.045 0.028701727 -11.78634 89.823176 297.91478 -2218.0894 + 500 0.05 0.028706691 -13.380919 101.39804 268.32933 -2218.0894 + 550 0.055 0.028714065 -14.824128 115.07511 245.62893 -2218.0893 + 600 0.06 0.028713691 -16.093505 128.58093 229.91054 -2218.089 + 650 0.065 0.028713232 -17.181217 140.22137 220.57591 -2218.089 + 700 0.07 0.02871245 -18.113035 149.60156 213.40077 -2218.0889 + 750 0.075 0.028712431 -18.954952 157.56849 206.80962 -2218.0891 + 800 0.08 0.02872489 -19.762756 164.91833 204.24742 -2218.0892 + 850 0.085 0.028733709 -20.538757 171.69348 203.73934 -2218.0894 + 900 0.09 0.028737031 -21.256095 177.71981 200.12043 -2218.0894 + 950 0.095 0.028743446 -21.908156 183.31613 195.23386 -2218.089 + 1000 0.1 0.028751809 -22.516179 189.01672 191.90401 -2218.0888 +Loop time of 5.71018 on 1 procs for 1000 steps with 500 atoms -Performance: 1.042 ns/day, 23.036 hours/ns, 120.585 timesteps/s -99.1% CPU use with 1 MPI tasks x 1 OpenMP threads +Performance: 1.513 ns/day, 15.862 hours/ns, 175.126 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 | 5.8835 | 5.8835 | 5.8835 | 0.0 | 35.47 -Neigh | 0.05244 | 0.05244 | 0.05244 | 0.0 | 0.32 -Comm | 0.092997 | 0.092997 | 0.092997 | 0.0 | 0.56 -Output | 5.213 | 5.213 | 5.213 | 0.0 | 31.43 -Modify | 5.3275 | 5.3275 | 5.3275 | 0.0 | 32.12 -Other | | 0.01636 | | | 0.10 +Pair | 2.7307 | 2.7307 | 2.7307 | 0.0 | 47.82 +Neigh | 0.018982 | 0.018982 | 0.018982 | 0.0 | 0.33 +Comm | 0.044032 | 0.044032 | 0.044032 | 0.0 | 0.77 +Output | 0.036037 | 0.036037 | 0.036037 | 0.0 | 0.63 +Modify | 2.8713 | 2.8713 | 2.8713 | 0.0 | 50.28 +Other | | 0.009135 | | | 0.16 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 Nghost: 1956 ave 1956 max 1956 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 19507 ave 19507 max 19507 min +Neighs: 19504 ave 19504 max 19504 min Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 39014 ave 39014 max 39014 min +FullNghs: 39008 ave 39008 max 39008 min Histogram: 1 0 0 0 0 0 0 0 0 0 -Total # of neighbors = 39014 -Ave neighs/atom = 78.028 -Neighbor list builds = 21 +Total # of neighbors = 39008 +Ave neighs/atom = 78.016 +Neighbor list builds = 9 Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:16 +Total wall time: 0:00:05 diff --git a/examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.4 b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 similarity index 52% rename from examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.4 rename to examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 index fd9ce80533..0657d43f8a 100644 --- a/examples/SPIN/nickel/log.30Apr19.spin.nickel_cubic.g++.4 +++ b/examples/SPIN/nickel/log.19Nov19.spin.nickel_cubic.g++.4 @@ -1,9 +1,7 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task +LAMMPS (30 Oct 2019) # fcc nickel in a 3d periodic box clear - using 1 OpenMP thread(s) per MPI task units metal atom_style spin @@ -21,7 +19,7 @@ Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - create_atoms CPU = 0.000639439 secs + create_atoms CPU = 0.000617027 secs # setting mass, mag. moments, and interactions for cobalt @@ -43,7 +41,7 @@ fix 1 all precession/spin cubic -0.0001 0.0 1.0 0.0 0.0 0.0 1.0 0.0 0.0 0.0 1. fix_modify 1 energy yes fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # compute and output options @@ -62,9 +60,9 @@ thermo_style custom step time v_magnorm v_emag temp v_tmag etotal thermo 50 compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] -run 2000 +run 1000 Neighbor list info ... update every 10 steps, delay 20 steps, check yes max neighbors/atom: 2000, page size: 100000 @@ -82,79 +80,59 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.298 | 7.298 | 7.298 Mbytes +Per MPI rank memory allocation (min/avg/max) = 7.799 | 7.799 | 7.799 Mbytes Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.455085 100.03408 -8603.706 -2218.0905 - 50 0.005 0.028732088 0.2980989 98.74184 -13360.862 -2218.0904 - 100 0.01 0.02873076 -0.32911738 97.074246 12749.405 -2218.09 - 150 0.015 0.028730298 -1.3537059 94.073558 3353.8731 -2218.0897 - 200 0.02 0.028733079 -2.6807428 89.419616 1868.0661 -2218.0895 - 250 0.025 0.028735725 -4.2256641 84.074249 1317.4563 -2218.0893 - 300 0.03 0.028728939 -5.9209085 80.063263 1033.1632 -2218.0893 - 350 0.035 0.028716731 -7.6957087 79.36782 849.1925 -2218.0893 - 400 0.04 0.02871114 -9.4720832 83.055773 718.36408 -2218.0893 - 450 0.045 0.02870879 -11.19254 91.28713 624.04151 -2218.0891 - 500 0.05 0.028708873 -12.832707 103.50343 551.85983 -2218.0892 - 550 0.055 0.028710315 -14.370603 118.16778 497.19527 -2218.0893 - 600 0.06 0.028707016 -15.769641 132.83264 462.57721 -2218.089 - 650 0.065 0.028706727 -17.018362 145.39247 445.40608 -2218.0888 - 700 0.07 0.028710482 -18.137792 154.80131 439.71677 -2218.0889 - 750 0.075 0.028705169 -19.130471 160.53663 437.67621 -2218.0892 - 800 0.08 0.028695336 -19.988452 162.95918 430.42912 -2218.089 - 850 0.085 0.028688393 -20.758389 164.33238 420.42991 -2218.0889 - 900 0.09 0.028684101 -21.521505 167.76167 412.29955 -2218.089 - 950 0.095 0.028684705 -22.314351 174.918 403.31757 -2218.0891 - 1000 0.1 0.028691284 -23.080026 184.60192 391.677 -2218.0893 - 1050 0.105 0.028687846 -23.714845 193.76312 379.81345 -2218.0893 - 1100 0.11 0.028682371 -24.191738 200.43041 372.65414 -2218.0893 - 1150 0.115 0.028684765 -24.569816 204.39323 368.53291 -2218.0891 - 1200 0.12 0.028678139 -24.892093 205.879 364.46365 -2218.0892 - 1250 0.125 0.028669738 -25.160227 205.09197 361.98015 -2218.0893 - 1300 0.13 0.028666626 -25.367813 202.69136 360.10649 -2218.0891 - 1350 0.135 0.028665511 -25.520784 199.79027 359.68033 -2218.0892 - 1400 0.14 0.02866749 -25.655936 197.91217 361.218 -2218.0892 - 1450 0.145 0.028666916 -25.80086 198.1933 361.5167 -2218.0889 - 1500 0.15 0.028660248 -25.953194 200.8243 356.0167 -2218.089 - 1550 0.155 0.028641778 -26.137444 205.80307 349.94961 -2218.0887 - 1600 0.16 0.028626894 -26.393372 212.6879 347.30341 -2218.0888 - 1650 0.165 0.028619835 -26.707923 219.63834 340.80511 -2218.0885 - 1700 0.17 0.028615681 -27.023214 224.25635 329.60947 -2218.0882 - 1750 0.175 0.02861597 -27.301445 225.47908 321.35253 -2218.0884 - 1800 0.18 0.028614544 -27.53764 224.03527 320.92639 -2218.0884 - 1850 0.185 0.02860894 -27.741581 221.74286 323.07034 -2218.0884 - 1900 0.19 0.028604135 -27.943034 220.659 322.60989 -2218.0884 - 1950 0.195 0.028602672 -28.160901 221.85908 318.8957 -2218.0885 - 2000 0.2 0.028597155 -28.365986 224.55298 311.53587 -2218.0886 -Loop time of 7.21663 on 4 procs for 2000 steps with 500 atoms + 0 0 0.028733803 0.455085 100.03408 -4301.853 -2218.0905 + 50 0.005 0.028732088 0.2980989 98.74184 -6680.4308 -2218.0904 + 100 0.01 0.02873076 -0.32911738 97.074246 6374.7026 -2218.09 + 150 0.015 0.028730298 -1.3537059 94.073558 1676.9365 -2218.0897 + 200 0.02 0.028733079 -2.6807428 89.419616 934.03305 -2218.0895 + 250 0.025 0.028735725 -4.2256641 84.074249 658.72816 -2218.0893 + 300 0.03 0.028728939 -5.9209085 80.063263 516.58161 -2218.0893 + 350 0.035 0.028716731 -7.6957087 79.36782 424.59625 -2218.0893 + 400 0.04 0.02871114 -9.4720832 83.055773 359.18204 -2218.0893 + 450 0.045 0.02870879 -11.19254 91.28713 312.02076 -2218.0891 + 500 0.05 0.028708873 -12.832707 103.50343 275.92991 -2218.0892 + 550 0.055 0.028710315 -14.370603 118.16778 248.59763 -2218.0893 + 600 0.06 0.028707016 -15.769641 132.83264 231.2886 -2218.089 + 650 0.065 0.028706727 -17.018362 145.39247 222.70304 -2218.0888 + 700 0.07 0.028710482 -18.137792 154.80131 219.85838 -2218.0889 + 750 0.075 0.028705169 -19.130471 160.53663 218.83811 -2218.0892 + 800 0.08 0.028695336 -19.988452 162.95918 215.21456 -2218.089 + 850 0.085 0.028688393 -20.758389 164.33238 210.21496 -2218.0889 + 900 0.09 0.028684101 -21.521505 167.76167 206.14977 -2218.089 + 950 0.095 0.028684705 -22.314351 174.918 201.65878 -2218.0891 + 1000 0.1 0.028691284 -23.080026 184.60192 195.8385 -2218.0893 +Loop time of 3.6142 on 4 procs for 1000 steps with 500 atoms -Performance: 2.394 ns/day, 10.023 hours/ns, 277.138 timesteps/s -98.1% CPU use with 4 MPI tasks x 1 OpenMP threads +Performance: 2.391 ns/day, 10.039 hours/ns, 276.686 timesteps/s +98.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 | 1.6337 | 1.6726 | 1.7259 | 2.7 | 23.18 -Neigh | 0.013023 | 0.01361 | 0.014188 | 0.4 | 0.19 -Comm | 0.19005 | 0.24933 | 0.2905 | 7.5 | 3.45 -Output | 1.4595 | 1.5171 | 1.5725 | 3.4 | 21.02 -Modify | 3.6943 | 3.7537 | 3.8093 | 2.3 | 52.01 -Other | | 0.01025 | | | 0.14 +Pair | 0.75407 | 0.87833 | 0.96493 | 8.8 | 24.30 +Neigh | 0.004509 | 0.0051936 | 0.0056126 | 0.6 | 0.14 +Comm | 0.19147 | 0.28312 | 0.4105 | 16.0 | 7.83 +Output | 0.013854 | 0.013948 | 0.014158 | 0.1 | 0.39 +Modify | 2.4267 | 2.4282 | 2.4319 | 0.1 | 67.19 +Other | | 0.005371 | | | 0.15 -Nlocal: 125 ave 132 max 121 min -Histogram: 2 0 0 0 1 0 0 0 0 1 -Nghost: 1099 ave 1103 max 1092 min -Histogram: 1 0 0 0 0 1 0 0 0 2 -Neighs: 4877 ave 5097 max 4747 min -Histogram: 2 0 0 0 1 0 0 0 0 1 -FullNghs: 9754 ave 10298 max 9440 min -Histogram: 2 0 0 0 1 0 0 0 0 1 +Nlocal: 125 ave 139 max 112 min +Histogram: 1 0 1 0 0 0 1 0 0 1 +Nghost: 1099 ave 1112 max 1085 min +Histogram: 1 0 0 1 0 0 0 1 0 1 +Neighs: 4876 ave 5385 max 4427 min +Histogram: 1 0 0 1 0 1 0 0 0 1 +FullNghs: 9752 ave 10845 max 8737 min +Histogram: 1 0 1 0 0 0 1 0 0 1 -Total # of neighbors = 39016 -Ave neighs/atom = 78.032 -Neighbor list builds = 21 +Total # of neighbors = 39008 +Ave neighs/atom = 78.016 +Neighbor list builds = 9 Dangerous builds = 0 Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:07 +Total wall time: 0:00:03 diff --git a/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.1 b/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.1 deleted file mode 100644 index 8d7284f5e2..0000000000 --- a/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.1 +++ /dev/null @@ -1,159 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# fcc nickel in a 3d periodic box - -clear - using 1 OpenMP thread(s) per MPI task -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice fcc 3.524 -Lattice spacing in x,y,z = 3.524 3.524 3.524 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) - 1 by 1 by 1 MPI processor grid -create_atoms 1 box -Created 500 atoms - create_atoms CPU = 0.000835896 secs - -# setting mass, mag. moments, and interactions for cobalt - -mass 1 58.69 - -set group all spin/random 31 0.63 - 500 settings made for spin/random -#set group all spin 0.63 0.0 0.0 1.0 -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Ni99.eam.alloy Ni -pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp v_tmag etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] - -run 2000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 5.90375 - ghost atom cutoff = 5.90375 - binsize = 2.95187, bins = 6 6 6 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.384 | 7.384 | 7.384 Mbytes -Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.40997576 100.03408 -9550.1342 -2218.1018 - 50 0.005 0.028733807 0.070491717 101.47879 -56307.038 -2218.1018 - 100 0.01 0.028733815 -0.70937134 101.7311 5851.6355 -2218.1018 - 150 0.015 0.028733823 -1.853981 99.63039 2395.8677 -2218.1018 - 200 0.02 0.028733828 -3.2679239 94.850105 1482.3486 -2218.1018 - 250 0.025 0.028733824 -4.863967 88.444584 1100.7396 -2218.1018 - 300 0.03 0.028733807 -6.5763457 82.689581 899.56642 -2218.1018 - 350 0.035 0.028733783 -8.3489158 80.108798 768.64457 -2218.1018 - 400 0.04 0.028733763 -10.120216 82.374947 670.03091 -2218.1018 - 450 0.045 0.028733755 -11.828932 89.814597 593.77931 -2218.1018 - 500 0.05 0.028733762 -13.423712 101.39613 535.03371 -2218.1018 - 550 0.055 0.028733783 -14.866724 115.07399 489.92024 -2218.1018 - 600 0.06 0.028733801 -16.135279 128.57849 458.66654 -2218.1018 - 650 0.065 0.028733804 -17.222838 140.22402 440.11437 -2218.1018 - 700 0.07 0.028733795 -18.154813 149.61295 425.91356 -2218.1018 - 750 0.075 0.028733781 -18.996903 157.5814 412.82654 -2218.1018 - 800 0.08 0.028733768 -19.804249 164.92075 407.77954 -2218.1018 - 850 0.085 0.028733752 -20.579151 171.67278 406.84726 -2218.1018 - 900 0.09 0.028733728 -21.294277 177.67238 399.69633 -2218.1018 - 950 0.095 0.028733715 -21.943945 183.2621 389.92281 -2218.1018 - 1000 0.1 0.02873374 -22.551277 188.99284 383.19592 -2218.1018 - 1050 0.105 0.028733783 -23.120147 194.51391 375.87245 -2218.1018 - 1100 0.11 0.028733792 -23.602325 198.18631 365.37753 -2218.1018 - 1150 0.115 0.028733774 -23.976048 199.04022 354.04863 -2218.1018 - 1200 0.12 0.02873376 -24.31575 198.41999 346.40397 -2218.1018 - 1250 0.125 0.028733759 -24.718347 198.3669 343.1701 -2218.1018 - 1300 0.13 0.028733765 -25.189073 199.57949 336.90052 -2218.1018 - 1350 0.135 0.028733774 -25.650252 201.45897 329.07023 -2218.1018 - 1400 0.14 0.028733785 -26.042702 203.6926 327.97373 -2218.1018 - 1450 0.145 0.028733791 -26.373965 206.80469 327.38747 -2218.1018 - 1500 0.15 0.028733791 -26.691802 211.43923 322.75885 -2218.1018 - 1550 0.155 0.028733794 -27.021573 217.10969 315.55781 -2218.1018 - 1600 0.16 0.028733792 -27.344066 222.16052 310.6743 -2218.1018 - 1650 0.165 0.028733788 -27.640017 225.28449 310.49671 -2218.1018 - 1700 0.17 0.028733803 -27.907241 226.37676 310.9389 -2218.1018 - 1750 0.175 0.028733828 -28.143477 226.31095 313.28034 -2218.1018 - 1800 0.18 0.028733833 -28.363397 226.43633 317.31668 -2218.1018 - 1850 0.185 0.028733811 -28.58153 227.36287 318.98645 -2218.1018 - 1900 0.19 0.028733796 -28.785208 228.39889 316.9972 -2218.1018 - 1950 0.195 0.028733826 -28.9724 228.84666 309.8027 -2218.1018 - 2000 0.2 0.02873386 -29.175039 228.918 297.88519 -2218.1018 -Loop time of 15.9256 on 1 procs for 2000 steps with 500 atoms - -Performance: 1.085 ns/day, 22.119 hours/ns, 125.584 timesteps/s -99.2% CPU use with 1 MPI tasks x 1 OpenMP threads - -MPI task timing breakdown: -Section | min time | avg time | max time |%varavg| %total ---------------------------------------------------------------- -Pair | 5.8677 | 5.8677 | 5.8677 | 0.0 | 36.84 -Neigh | 0.051965 | 0.051965 | 0.051965 | 0.0 | 0.33 -Comm | 0.088829 | 0.088829 | 0.088829 | 0.0 | 0.56 -Output | 4.7019 | 4.7019 | 4.7019 | 0.0 | 29.52 -Modify | 5.199 | 5.199 | 5.199 | 0.0 | 32.65 -Other | | 0.01632 | | | 0.10 - -Nlocal: 500 ave 500 max 500 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Nghost: 1956 ave 1956 max 1956 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -Neighs: 19508 ave 19508 max 19508 min -Histogram: 1 0 0 0 0 0 0 0 0 0 -FullNghs: 39016 ave 39016 max 39016 min -Histogram: 1 0 0 0 0 0 0 0 0 0 - -Total # of neighbors = 39016 -Ave neighs/atom = 78.032 -Neighbor list builds = 21 -Dangerous builds = 0 - - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:16 diff --git a/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.4 b/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.4 deleted file mode 100644 index a186253db3..0000000000 --- a/examples/SPIN/nickel/log.30Apr19.spin.nickel.g++.4 +++ /dev/null @@ -1,159 +0,0 @@ -LAMMPS (30 Apr 2019) - using 1 OpenMP thread(s) per MPI task -# fcc nickel in a 3d periodic box - -clear - using 1 OpenMP thread(s) per MPI task -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -lattice fcc 3.524 -Lattice spacing in x,y,z = 3.524 3.524 3.524 -region box block 0.0 5.0 0.0 5.0 0.0 5.0 -create_box 1 box -Created orthogonal box = (0 0 0) to (17.62 17.62 17.62) - 1 by 2 by 2 MPI processor grid -create_atoms 1 box -Created 500 atoms - create_atoms CPU = 0.000492096 secs - -# setting mass, mag. moments, and interactions for cobalt - -mass 1 58.69 - -set group all spin/random 31 0.63 - 500 settings made for spin/random -#set group all spin 0.63 0.0 0.0 1.0 -velocity all create 100 4928459 rot yes dist gaussian - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Ni99.eam.alloy Ni -pair_coeff * * spin/exchange exchange 4.0 0.50 0.2280246862 1.229983475 - -neighbor 0.1 bin -neigh_modify every 10 check yes delay 20 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# compute and output options - -compute out_mag all spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo_style custom step time v_magnorm v_emag temp v_tmag etotal -thermo 50 - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 50 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] - -run 2000 -Neighbor list info ... - update every 10 steps, delay 20 steps, check yes - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 5.90375 - ghost atom cutoff = 5.90375 - binsize = 2.95187, bins = 6 6 6 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.298 | 7.298 | 7.298 Mbytes -Step Time v_magnorm v_emag Temp v_tmag TotEng - 0 0 0.028733803 0.40997576 100.03408 -9550.1342 -2218.1018 - 50 0.005 0.028733805 0.25324083 98.741633 -15727.749 -2218.1018 - 100 0.01 0.028733812 -0.37320751 97.073875 11244.373 -2218.1018 - 150 0.015 0.028733819 -1.3971549 94.073447 3250.0517 -2218.1018 - 200 0.02 0.028733825 -2.7238372 89.419944 1838.752 -2218.1018 - 250 0.025 0.028733829 -4.2684428 84.07494 1304.3675 -2218.1018 - 300 0.03 0.028733824 -5.9636712 80.06368 1025.7815 -2218.1018 - 350 0.035 0.02873381 -7.7386326 79.366702 844.49729 -2218.1018 - 400 0.04 0.028733802 -9.5148059 83.052751 715.20758 -2218.1018 - 450 0.045 0.028733806 -11.234935 91.282747 621.75552 -2218.1018 - 500 0.05 0.02873381 -12.875184 103.49836 550.04479 -2218.1018 - 550 0.055 0.028733808 -14.413473 118.16526 495.70417 -2218.1018 - 600 0.06 0.028733803 -15.812466 132.83837 461.35805 -2218.1018 - 650 0.065 0.028733808 -17.061311 145.41049 444.38951 -2218.1018 - 700 0.07 0.028733818 -18.181903 154.83414 438.85866 -2218.1018 - 750 0.075 0.028733823 -19.176259 160.58645 436.90462 -2218.1018 - 800 0.08 0.028733825 -20.035157 163.02829 429.73193 -2218.1018 - 850 0.085 0.028733825 -20.806548 164.4197 419.73763 -2218.1018 - 900 0.09 0.028733829 -21.571419 167.8571 411.59699 -2218.1018 - 950 0.095 0.028733825 -22.365879 175.00875 402.66175 -2218.1018 - 1000 0.1 0.028733821 -23.133464 184.68305 391.05824 -2218.1018 - 1050 0.105 0.028733833 -23.770507 193.83795 379.23354 -2218.1018 - 1100 0.11 0.02873385 -24.249882 200.5039 372.08521 -2218.1018 - 1150 0.115 0.028733864 -24.630489 204.46984 367.92135 -2218.1018 - 1200 0.12 0.028733877 -24.956281 205.96624 363.72367 -2218.1018 - 1250 0.125 0.028733884 -25.227332 205.18503 361.09236 -2218.1018 - 1300 0.13 0.028733877 -25.43568 202.76969 359.10924 -2218.1018 - 1350 0.135 0.028733868 -25.588748 199.85462 358.69556 -2218.1018 - 1400 0.14 0.028733866 -25.723582 197.99165 360.27856 -2218.1018 - 1450 0.145 0.028733851 -25.866283 198.30283 360.46623 -2218.1018 - 1500 0.15 0.028733812 -26.014569 200.95517 354.66722 -2218.1018 - 1550 0.155 0.02873379 -26.192673 205.95485 348.37935 -2218.1018 - 1600 0.16 0.028733795 -26.444059 212.87557 345.53576 -2218.1018 - 1650 0.165 0.028733838 -26.75551 219.86449 338.9224 -2218.1018 - 1700 0.17 0.028733868 -27.068513 224.47868 327.81241 -2218.1018 - 1750 0.175 0.028733862 -27.344118 225.62318 319.85486 -2218.1018 - 1800 0.18 0.028733849 -27.57563 224.07463 320.07064 -2218.1018 - 1850 0.185 0.028733852 -27.774274 221.70618 323.12599 -2218.1018 - 1900 0.19 0.028733864 -27.967999 220.53947 322.9504 -2218.1018 - 1950 0.195 0.028733863 -28.173041 221.61407 318.63401 -2218.1018 - 2000 0.2 0.028733853 -28.362177 224.22281 310.55185 -2218.1018 -Loop time of 7.69012 on 4 procs for 2000 steps with 500 atoms - -Performance: 2.247 ns/day, 10.681 hours/ns, 260.074 timesteps/s -98.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 | 1.5623 | 1.5999 | 1.6541 | 2.7 | 20.80 -Neigh | 0.012559 | 0.013043 | 0.013682 | 0.4 | 0.17 -Comm | 0.1843 | 0.24254 | 0.27935 | 7.2 | 3.15 -Output | 1.4749 | 1.5228 | 1.5694 | 2.9 | 19.80 -Modify | 4.2492 | 4.3019 | 4.3507 | 1.8 | 55.94 -Other | | 0.009925 | | | 0.13 - -Nlocal: 125 ave 132 max 120 min -Histogram: 2 0 0 0 0 1 0 0 0 1 -Nghost: 1099 ave 1104 max 1092 min -Histogram: 1 0 0 0 1 0 0 0 0 2 -Neighs: 4876.5 ave 5100 max 4721 min -Histogram: 2 0 0 0 0 1 0 0 0 1 -FullNghs: 9753 ave 10296 max 9362 min -Histogram: 2 0 0 0 0 1 0 0 0 1 - -Total # of neighbors = 39012 -Ave neighs/atom = 78.024 -Neighbor list builds = 21 -Dangerous builds = 0 - - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:07 diff --git a/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy b/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy deleted file mode 120000 index 6a47c9eebe..0000000000 --- a/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy +++ /dev/null @@ -1 +0,0 @@ -../cobalt_fcc/Co_PurjaPun_2012.eam.alloy \ No newline at end of file diff --git a/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy b/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy new file mode 100644 index 0000000000..3af058baf7 --- /dev/null +++ b/examples/SPIN/read_restart/Co_PurjaPun_2012.eam.alloy @@ -0,0 +1,6006 @@ +Cobalt EAM potential: G. P. Purja Pun and Y. Mishin, Phys. Rev. B xx, 004100 (2012) (in press) +Data below r = 1.5 A is extrapolated. F(Rho) data not extrapolated. +Created on Wed Sep 26 17:29:54 2012 +1 Co +10000 4.788742913000000e-04 10000 6.499539000000001e-04 6.499539000000000e+00 +27 5.893320000000000e+01 2.507000000000000e+00 hcp + -1.680303080000000e-02 -1.879913964471138e-02 -2.091739081044659e-02 -2.303564197615629e-02 -2.503175082079116e-02 + -2.681996612041136e-02 -2.846010103933253e-02 -3.003179469400266e-02 -3.154842562124295e-02 -3.300931506782415e-02 + -3.442381570000001e-02 -3.580233366714632e-02 -3.714945763166951e-02 -3.846832763111274e-02 -3.976210669053554e-02 + -4.103374908125148e-02 -4.228535107207521e-02 -4.351872320172212e-02 -4.473539109100971e-02 -4.593674531110434e-02 + -4.712392115246503e-02 -4.829795108118731e-02 -4.945971154662068e-02 -5.061001094949964e-02 -5.174954151284258e-02 + -5.287894548568519e-02 -5.399878139884967e-02 -5.510957102742049e-02 -5.621177284174523e-02 -5.730581735016625e-02 + -5.839208651773948e-02 -5.947094067448531e-02 -6.054270215356945e-02 -6.160767623453070e-02 -6.266613797925552e-02 + -6.371834880435967e-02 -6.476454576302854e-02 -6.580495483863194e-02 -6.683978209870683e-02 -6.786922452279202e-02 + -6.889346265426707e-02 -6.991266949659354e-02 -7.092700432972064e-02 -7.193662011890395e-02 -7.294165829413661e-02 + -7.394225494811188e-02 -7.493853635958479e-02 -7.593062425993033e-02 -7.691863200494162e-02 -7.790266905197404e-02 + -7.888283764021425e-02 -7.985923664258643e-02 -8.083195868513401e-02 -8.180109346997461e-02 -8.276672525040257e-02 + -8.372893572415932e-02 -8.468780181559693e-02 -8.564339820511864e-02 -8.659579537072190e-02 -8.754506181558984e-02 + -8.849126234605453e-02 -8.943446001410092e-02 -9.037471455117625e-02 -9.131208412841478e-02 -9.224662399623559e-02 + -9.317838801321032e-02 -9.410742739123597e-02 -9.503379209498646e-02 -9.595752974691800e-02 -9.687868684755546e-02 + -9.779730775191570e-02 -9.871343580120046e-02 -9.962711242685958e-02 -1.005383781439554e-01 -1.014472717117523e-01 + -1.023538310651938e-01 -1.032580925977369e-01 -1.041600919387366e-01 -1.050598632026273e-01 -1.059574398208095e-01 + -1.068528540074704e-01 -1.077461373458066e-01 -1.086373201122683e-01 -1.095264320028559e-01 -1.104135016985198e-01 + -1.112985573626335e-01 -1.121816261033156e-01 -1.130627345294291e-01 -1.139419083080692e-01 -1.148191726662944e-01 + -1.156945520127823e-01 -1.165680703406650e-01 -1.174397507992727e-01 -1.183096161572101e-01 -1.191776885039839e-01 + -1.200439895800373e-01 -1.209085404086571e-01 -1.217713616730546e-01 -1.226324734132936e-01 -1.234918953788508e-01 + -1.243496468000000e-01 -1.252057466264230e-01 -1.260602132046348e-01 -1.269130646065986e-01 -1.277643184092350e-01 + -1.286139919512837e-01 -1.294621021138015e-01 -1.303086655551642e-01 -1.311536985007052e-01 -1.319972169590798e-01 + -1.328392365052704e-01 -1.336797725161469e-01 -1.345188400098036e-01 -1.353564538215464e-01 -1.361926284143060e-01 + -1.370273780803152e-01 -1.378607168013910e-01 -1.386926583917836e-01 -1.395232163058920e-01 -1.403524038515728e-01 + -1.411802341103638e-01 -1.420067200256853e-01 -1.428318742148069e-01 -1.436557091565456e-01 -1.444782371020595e-01 + -1.452994701862315e-01 -1.461194203065015e-01 -1.469380992388567e-01 -1.477555185109162e-01 -1.485716895480879e-01 + -1.493866236153044e-01 -1.502003318703277e-01 -1.510128252027127e-01 -1.518241144121522e-01 -1.526342102070998e-01 + -1.534431232126203e-01 -1.542508638114616e-01 -1.550574422930448e-01 -1.558628688157988e-01 -1.566671534698807e-01 + -1.574703062033520e-01 -1.582723368973844e-01 -1.590732553076882e-01 -1.598730711132973e-01 -1.606717938120008e-01 + -1.614694328459875e-01 -1.622659976162905e-01 -1.630614974730487e-01 -1.638559416039789e-01 -1.646493391351259e-01 + -1.654416991082678e-01 -1.662330305252601e-01 -1.670233423125346e-01 -1.678126433512354e-01 -1.686009424167802e-01 + -1.693882482431861e-01 -1.701745695045948e-01 -1.709599148401449e-01 -1.717442928088396e-01 -1.725277119385885e-01 + -1.733101807130639e-01 -1.740917075837066e-01 -1.748723009172683e-01 -1.756519690655456e-01 -1.764307204052008e-01 + -1.772085632840185e-01 -1.779855059094047e-01 -1.787615564692287e-01 -1.795367232135896e-01 -1.803110143830451e-01 + -1.810844381177561e-01 -1.818570025406103e-01 -1.826287158057983e-01 -1.833995860626770e-01 -1.841696214099643e-01 + -1.849388299454831e-01 -1.857072198141128e-01 -1.864747991526175e-01 -1.872415760182443e-01 -1.880075584641173e-01 + -1.887727546063884e-01 -1.895371725773110e-01 -1.903008205105196e-01 -1.910637065418589e-01 -1.918258388146347e-01 + -1.925872254807121e-01 -1.933478747187342e-01 -1.941077947209150e-01 -1.948669937069724e-01 -1.956254799127480e-01 + -1.963832616110719e-01 -1.971403470967068e-01 -1.978967447151567e-01 -1.986524628291068e-01 -1.994075098192274e-01 + -2.001618941005484e-01 -2.009156242075518e-01 -2.016687086990372e-01 -2.024211561116226e-01 -2.031729750127928e-01 + -2.039241741156804e-01 -2.046747621691974e-01 -2.054247479197256e-01 -2.061741401521784e-01 -2.069229478081280e-01 + -2.076711798806499e-01 -2.084188454121736e-01 -2.091659534755806e-01 -2.099125132162076e-01 -2.106585338443872e-01 + -2.114040247579823e-01 -2.121489953974893e-01 -2.128934551864067e-01 -2.136374136027109e-01 -2.143808803592873e-01 + -2.151238652468154e-01 -2.158663781322411e-01 -2.166084289346303e-01 -2.173500277052638e-01 -2.180911845646947e-01 + -2.188319097783510e-01 -2.195722136949507e-01 -2.203121068514981e-01 -2.210515998518519e-01 -2.217907033790026e-01 + -2.225294282016381e-01 -2.232677853521022e-01 -2.240057859531163e-01 -2.247434412252567e-01 -2.254807624804862e-01 + -2.262177612984613e-01 -2.269544493586047e-01 -2.276908384717110e-01 -2.284269405581227e-01 -2.291627678450005e-01 + -2.298983326532392e-01 -2.306336473718499e-01 -2.313687245044682e-01 -2.321035769451089e-01 -2.328382177230701e-01 + -2.335726600184018e-01 -2.343069171312917e-01 -2.350410026917230e-01 -2.357749304696442e-01 -2.365087144650665e-01 + -2.372423688046511e-01 -2.379759078915950e-01 -2.387093462817347e-01 -2.394426988649284e-01 -2.401759806938325e-01 + -2.409092071382775e-01 -2.416423937275558e-01 -2.423755563116356e-01 -2.431087109081851e-01 -2.438418738849959e-01 + -2.445750618045980e-01 -2.453082916583512e-01 -2.460415806101058e-01 -2.467749460848467e-01 -2.475084057095742e-01 + -2.482419776582159e-01 -2.489756803241430e-01 -2.497095324315720e-01 -2.504435529132133e-01 -2.511777612049070e-01 + -2.519121769824342e-01 -2.526468203782122e-01 -2.533817117688987e-01 -2.541168720514789e-01 -2.548523223627430e-01 + -2.555880842783758e-01 -2.563241796571988e-01 -2.570606310516858e-01 -2.577974612919421e-01 -2.585346936249472e-01 + -2.592723515924181e-01 -2.600104594981498e-01 -2.607490419576605e-01 -2.614881240712832e-01 -2.622277312727207e-01 + -2.629678898443362e-01 -2.637086264051527e-01 -2.644499680721714e-01 -2.651919423187013e-01 -2.659345775453039e-01 + -2.666779025531186e-01 -2.674219468183432e-01 -2.681667401972407e-01 -2.689123133912765e-01 -2.696586975492495e-01 + -2.704059247640904e-01 -2.711540275538941e-01 -2.719030391932789e-01 -2.726529934197978e-01 -2.734039250662187e-01 + -2.741558694758598e-01 -2.749088629390239e-01 -2.756629422674556e-01 -2.764181454116789e-01 -2.771745108563868e-01 + -2.779320780841674e-01 -2.786908871694924e-01 -2.794509795564719e-01 -2.802123972949423e-01 -2.809751834880072e-01 + -2.817393818716988e-01 -2.825050376604960e-01 -2.832721967688652e-01 -2.840409064327807e-01 -2.848112145951165e-01 + -2.855831707048412e-01 -2.863568249759762e-01 -2.871322291766564e-01 -2.879094358829076e-01 -2.886884993482028e-01 + -2.894694746623641e-01 -2.902524185831628e-01 -2.910373887617654e-01 -2.918244447549689e-01 -2.926136470970381e-01 + -2.934050583264800e-01 -2.941987419693519e-01 -2.949947634976693e-01 -2.957931894604184e-01 -2.965940887685082e-01 + -2.973975314584912e-01 -2.982035897075678e-01 -2.990123368838905e-01 -2.998238489787670e-01 -3.006382032814213e-01 + -3.014554796495834e-01 -3.022757592753754e-01 -3.030991261199829e-01 -3.039256655881672e-01 -3.047554660899296e-01 + -3.055886175640754e-01 -3.064252130593845e-01 -3.072653472379187e-01 -3.081091181048918e-01 -3.089566254021406e-01 + -3.098079724748395e-01 -3.106632645082006e-01 -3.115226104442510e-01 -3.123861211846884e-01 -3.132539117130802e-01 + -3.141260990998875e-01 -3.150028046812773e-01 -3.158841520361693e-01 -3.167702694487885e-01 -3.176612875689104e-01 + -3.185573418032087e-01 -3.194585700942650e-01 -3.203651157713922e-01 -3.212771249044592e-01 -3.221947491388281e-01 + -3.231181430183639e-01 -3.240474671054514e-01 -3.249828850672117e-01 -3.259245669711927e-01 -3.268726862299913e-01 + -3.278274232359761e-01 -3.287889619469540e-01 -3.297574936027157e-01 -3.307332132733838e-01 -3.317163240684192e-01 + -3.327070332351553e-01 -3.337055565330767e-01 -3.347121141277095e-01 -3.357269352965953e-01 -3.367502540927247e-01 + -3.377823145588749e-01 -3.388233658450175e-01 -3.398736675401181e-01 -3.409334847493447e-01 -3.420030942036733e-01 + -3.430827786115977e-01 -3.441728329658748e-01 -3.452735586625544e-01 -3.463852704265985e-01 -3.475082899277179e-01 + -3.486429532857090e-01 -3.497896041380748e-01 -3.509486017430585e-01 -3.521203134619261e-01 -3.533051234472958e-01 + -3.545034246605078e-01 -3.557156285064298e-01 -3.569421559513399e-01 -3.581834477636310e-01 -3.594399550688090e-01 + -3.607121506187135e-01 -3.620005184199024e-01 -3.633055658714727e-01 -3.646278119965309e-01 -3.659677989216845e-01 + -3.673260803339768e-01 -3.687032330586966e-01 -3.700998457090232e-01 -3.715165309114429e-01 -3.729539131544640e-01 + -3.744126403613781e-01 -3.758933720658462e-01 -3.773967908082255e-01 -3.789235902651524e-01 -3.804744856516886e-01 + -3.820502023195389e-01 -3.836514846285581e-01 -3.852790856353807e-01 -3.869337741756033e-01 -3.886163256972291e-01 + -3.903275263189269e-01 -3.920681658458204e-01 -3.938390381581898e-01 -3.956409370872805e-01 -3.974746521930466e-01 + -3.993409682701225e-01 -4.012406553231547e-01 -4.031744727439548e-01 -4.051431522629808e-01 -4.071474082130475e-01 + -4.091879129977703e-01 -4.112653138348391e-01 -4.133801991274390e-01 -4.155331235094092e-01 -4.177245653517079e-01 + -4.199549603385881e-01 -4.222246496703586e-01 -4.245339230260172e-01 -4.268829584832519e-01 -4.292718744431503e-01 + -4.317006622016948e-01 -4.341692468068394e-01 -4.366774154195978e-01 -4.392248845800756e-01 -4.418112262316757e-01 + -4.444359401252420e-01 -4.470983818380713e-01 -4.497978365893122e-01 -4.525334523390530e-01 -4.553043120100788e-01 + -4.581093756350076e-01 -4.609475466791835e-01 -4.638176252290113e-01 -4.667183660407072e-01 -4.696484459287199e-01 + -4.726065094563343e-01 -4.755911501239359e-01 -4.786009429283761e-01 -4.816344399152602e-01 -4.846901882843556e-01 + -4.877667388033212e-01 -4.908626497957108e-01 -4.939765062407663e-01 -4.971069114027755e-01 -5.002525150305011e-01 + -5.034119937007041e-01 -5.065840848176727e-01 -5.097675587133593e-01 -5.129612566028576e-01 -5.161640565945169e-01 + -5.193749134865747e-01 -5.225928209640586e-01 -5.258168515692775e-01 -5.290461169135583e-01 -5.322798060270272e-01 + -5.355171460831645e-01 -5.387574394100244e-01 -5.420000245805213e-01 -5.452443099924439e-01 -5.484897376520451e-01 + -5.517358141745681e-01 -5.549820769247875e-01 -5.582281216566209e-01 -5.614735718423751e-01 -5.647181034387753e-01 + -5.679614169890416e-01 -5.712032588979591e-01 -5.744433972991336e-01 -5.776816413798681e-01 -5.809178193507762e-01 + -5.841517944620215e-01 -5.873834463985003e-01 -5.906126855444893e-01 -5.938394364748391e-01 -5.970636498273136e-01 + -6.002852884426439e-01 -6.035043379105128e-01 -6.067207941645156e-01 -6.099346717649501e-01 -6.131459940881434e-01 + -6.163548011478311e-01 -6.195611404873568e-01 -6.227650731310865e-01 -6.259666663617727e-01 -6.291659990146931e-01 + -6.323631552654742e-01 -6.355582290986170e-01 -6.387513188871106e-01 -6.419425307490256e-01 -6.451319745539882e-01 + -6.483197674327603e-01 -6.515060293214946e-01 -6.546908841167685e-01 -6.578744572836812e-01 -6.610568766009968e-01 + -6.642382709221243e-01 -6.674187710853904e-01 -6.705985088370179e-01 -6.737776175698923e-01 -6.769562312911304e-01 + -6.801344848181089e-01 -6.833125134999645e-01 -6.864904540026142e-01 -6.896684434132225e-01 -6.928466191871651e-01 + -6.960251190039876e-01 -6.992040810717012e-01 -7.023836437724149e-01 -7.055639456561626e-01 -7.087451254024176e-01 + -7.119273220404884e-01 -7.151106745784721e-01 -7.182953215897911e-01 -7.214814016245582e-01 -7.246690535743215e-01 + -7.278584163200112e-01 -7.310496283586513e-01 -7.342428280442573e-01 -7.374381535427195e-01 -7.406357429444993e-01 + -7.438357342264661e-01 -7.470382651689156e-01 -7.502434728794412e-01 -7.534514943101106e-01 -7.566624664635970e-01 + -7.598765262236051e-01 -7.630938099473661e-01 -7.663144537782537e-01 -7.695385935306881e-01 -7.727663648349232e-01 + -7.759979029135046e-01 -7.792333428394971e-01 -7.824728194957561e-01 -7.857164675195603e-01 -7.889644207560909e-01 + -7.922168128628783e-01 -7.954737775389469e-01 -7.987354483417761e-01 -8.020019582211745e-01 -8.052734399002169e-01 + -8.085500258027153e-01 -8.118318481538471e-01 -8.151190386835121e-01 -8.184117289678831e-01 -8.217100504635063e-01 + -8.250141343769457e-01 -8.283241110344656e-01 -8.316401105683494e-01 -8.349622632152548e-01 -8.382906990624389e-01 + -8.416255474951805e-01 -8.449669376504778e-01 -8.483149983741850e-01 -8.516698583310095e-01 -8.550316457522134e-01 + -8.584004886419279e-01 -8.617765145292081e-01 -8.651598508088844e-01 -8.685506248139727e-01 -8.719489622521989e-01 + -8.753549823919468e-01 -8.787687997490927e-01 -8.821905162688262e-01 -8.856202278084699e-01 -8.890580184445617e-01 + -8.925039663319011e-01 -8.959581377191167e-01 -8.994205926453692e-01 -9.028913782181163e-01 -9.063705352609543e-01 + -9.098580923937473e-01 -9.133540718558304e-01 -9.168584825681617e-01 -9.203713268261465e-01 -9.238925937413506e-01 + -9.274222656928153e-01 -9.309603113133150e-01 -9.345066924037853e-01 -9.380613571840678e-01 -9.416242468397124e-01 + -9.451952880001965e-01 -9.487744002152808e-01 -9.523614892719469e-01 -9.559564538973973e-01 -9.595591783425093e-01 + -9.631695396882074e-01 -9.667874008119273e-01 -9.704126174878044e-01 -9.740450312802591e-01 -9.776844767743714e-01 + -9.813307748475731e-01 -9.849837394560669e-01 -9.886431705787867e-01 -9.923088615430331e-01 -9.959805930468456e-01 + -9.996581394281877e-01 -1.003341262213973e+00 -1.007029716826452e+00 -1.010723247080268e+00 -1.014421591236032e+00 + -1.018124476945841e+00 -1.021831626529500e+00 -1.025542751586175e+00 -1.029257558992056e+00 -1.032975747452084e+00 + -1.036697011770175e+00 -1.040421039317395e+00 -1.044147513860548e+00 -1.047876112182243e+00 -1.051606508161453e+00 + -1.055338371046766e+00 -1.059071368055605e+00 -1.062805162911107e+00 -1.066539417837194e+00 -1.070273792555226e+00 + -1.074007946119602e+00 -1.077741537419413e+00 -1.081474225260823e+00 -1.085205668283577e+00 -1.088935525821090e+00 + -1.092663460147868e+00 -1.096389134999202e+00 -1.100112217012435e+00 -1.103832374788097e+00 -1.107549281877421e+00 + -1.111262614364874e+00 -1.114972053517157e+00 -1.118677283811066e+00 -1.122377997381517e+00 -1.126073890115035e+00 + -1.129764665246453e+00 -1.133450029987863e+00 -1.137129700112097e+00 -1.140803395884355e+00 -1.144470846978575e+00 + -1.148131787996958e+00 -1.151785963846005e+00 -1.155433124321719e+00 -1.159073028473816e+00 -1.162705440550504e+00 + -1.166330136340245e+00 -1.169946897198408e+00 -1.173555515207745e+00 -1.177155787675114e+00 -1.180747522076412e+00 + -1.184330531453910e+00 -1.187904640946331e+00 -1.191469681045491e+00 -1.195025491559137e+00 -1.198571917630371e+00 + -1.202108816427798e+00 -1.205636050425976e+00 -1.209153491297797e+00 -1.212661015717853e+00 -1.216158511169199e+00 + -1.219645870103956e+00 -1.223122994042052e+00 -1.226589789250444e+00 -1.230046171916402e+00 -1.233492062734542e+00 + -1.236927390508550e+00 -1.240352088211073e+00 -1.243766097381527e+00 -1.247169363751694e+00 -1.250561841256042e+00 + -1.253943487695246e+00 -1.257314268132119e+00 -1.260674151007197e+00 -1.264023111009775e+00 -1.267361126327042e+00 + -1.270688182889021e+00 -1.274004269717549e+00 -1.277309380458899e+00 -1.280603511471348e+00 -1.283886665336751e+00 + -1.287158847447705e+00 -1.290420068216200e+00 -1.293670340397085e+00 -1.296909681097245e+00 -1.300138109654688e+00 + -1.303355649979877e+00 -1.306562327924205e+00 -1.309758172530325e+00 -1.312943214678930e+00 -1.316117489411603e+00 + -1.319281033477409e+00 -1.322433886294459e+00 -1.325576088655014e+00 -1.328707684178879e+00 -1.331828717822939e+00 + -1.334939237064845e+00 -1.338039290534788e+00 -1.341128928952336e+00 -1.344208204044806e+00 -1.347277169481128e+00 + -1.350335879836220e+00 -1.353384391367341e+00 -1.356422761075585e+00 -1.359451047255056e+00 -1.362469308854003e+00 + -1.365477606144248e+00 -1.368475999956682e+00 -1.371464552034891e+00 -1.374443324607048e+00 -1.377412380926959e+00 + -1.380371784452904e+00 -1.383321598435415e+00 -1.386261886043311e+00 -1.389192710326296e+00 -1.392114134331963e+00 + -1.395026221218571e+00 -1.397929034013782e+00 -1.400822635112213e+00 -1.403707086730599e+00 -1.406582451007194e+00 + -1.409448790047375e+00 -1.412306165903488e+00 -1.415154640386279e+00 -1.417994274393129e+00 -1.420825128672226e+00 + -1.423647264288326e+00 -1.426460742270041e+00 -1.429265623184807e+00 -1.432061967292326e+00 -1.434849834082543e+00 + -1.437629282863016e+00 -1.440400372981510e+00 -1.443163163644870e+00 -1.445917713456040e+00 -1.448664080745027e+00 + -1.451402323353998e+00 -1.454132498983212e+00 -1.456854665253158e+00 -1.459568879518891e+00 -1.462275198153495e+00 + -1.464973677286479e+00 -1.467664373054985e+00 -1.470347341460922e+00 -1.473022637957602e+00 -1.475690317602213e+00 + -1.478350434416031e+00 -1.481003042251009e+00 -1.483648195317718e+00 -1.486285947650543e+00 -1.488916352220507e+00 + -1.491539461636770e+00 -1.494155328124374e+00 -1.496764003712290e+00 -1.499365540029296e+00 -1.501959988475343e+00 + -1.504547399935251e+00 -1.507127824972320e+00 -1.509701313378898e+00 -1.512267914702716e+00 -1.514827678283996e+00 + -1.517380653263305e+00 -1.519926888190102e+00 -1.522466431291609e+00 -1.524999330097196e+00 -1.527525631932397e+00 + -1.530045384005255e+00 -1.532558633226744e+00 -1.535065425437065e+00 -1.537565806237489e+00 -1.540059821344337e+00 + -1.542547516227056e+00 -1.545028935252552e+00 -1.547504122520188e+00 -1.549973122161691e+00 -1.552435978060152e+00 + -1.554892733071735e+00 -1.557343429814709e+00 -1.559788110982664e+00 -1.562226819032855e+00 -1.564659595401864e+00 + -1.567086481207361e+00 -1.569507517312065e+00 -1.571922744465970e+00 -1.574332203223133e+00 -1.576735933784567e+00 + -1.579133975135047e+00 -1.581526366095511e+00 -1.583913146047792e+00 -1.586294354132112e+00 -1.588670027961349e+00 + -1.591040204840321e+00 -1.593404922368944e+00 -1.595764217997401e+00 -1.598118128281829e+00 -1.600466689560657e+00 + -1.602809938195509e+00 -1.605147910317183e+00 -1.607480641109968e+00 -1.609808165462235e+00 -1.612130518025190e+00 + -1.614447733364541e+00 -1.616759845941160e+00 -1.619066889913862e+00 -1.621368898338053e+00 -1.623665904067572e+00 + -1.625957940253400e+00 -1.628245039905108e+00 -1.630527235169479e+00 -1.632804557955816e+00 -1.635077040086276e+00 + -1.637344713164072e+00 -1.639607608003776e+00 -1.641865755216986e+00 -1.644119185392045e+00 -1.646367929030376e+00 + -1.648612016308968e+00 -1.650851477080719e+00 -1.653086340226579e+00 -1.655316634503563e+00 -1.657542389144867e+00 + -1.659763633269537e+00 -1.661980395063818e+00 -1.664192702419508e+00 -1.666400582983419e+00 -1.668604064251645e+00 + -1.670803173362428e+00 -1.672997937236383e+00 -1.675188382281491e+00 -1.677374534802169e+00 -1.679556421201192e+00 + -1.681734067628149e+00 -1.683907499121518e+00 -1.686076740528519e+00 -1.688241817042459e+00 -1.690402753749855e+00 + -1.692559574964003e+00 -1.694712304797627e+00 -1.696860967334408e+00 -1.699005586454806e+00 -1.701146185255449e+00 + -1.703282786721620e+00 -1.705415414177082e+00 -1.707544090831449e+00 -1.709668839099297e+00 -1.711789681156861e+00 + -1.713906639022084e+00 -1.716019734585396e+00 -1.718128989385494e+00 -1.720234424849230e+00 -1.722336062307809e+00 + -1.724433922917529e+00 -1.726528027230686e+00 -1.728618395721282e+00 -1.730705049154116e+00 -1.732788008101886e+00 + -1.734867292078088e+00 -1.736942920442919e+00 -1.739014913002594e+00 -1.741083289547465e+00 -1.743148069358425e+00 + -1.745209271450225e+00 -1.747266914282488e+00 -1.749321016270471e+00 -1.751371596207075e+00 -1.753418672811714e+00 + -1.755462264132180e+00 -1.757502388000569e+00 -1.759539062057792e+00 -1.761572303881055e+00 -1.763602130983907e+00 + -1.765628560778196e+00 -1.767651610332621e+00 -1.769671296580689e+00 -1.771687636258316e+00 -1.773700645994041e+00 + -1.775710342184503e+00 -1.777716741146727e+00 -1.779719859111176e+00 -1.781719712181211e+00 -1.783716316038327e+00 + -1.785709686327057e+00 -1.787699838965949e+00 -1.789686789700248e+00 -1.791670553307960e+00 -1.793651144443631e+00 + -1.795628578235185e+00 -1.797602869852874e+00 -1.799574034162875e+00 -1.801542085839167e+00 -1.803507039091021e+00 + -1.805468908052258e+00 -1.807427707019619e+00 -1.809383450209764e+00 -1.811336151356113e+00 -1.813285824110837e+00 + -1.815232482284336e+00 -1.817176139592257e+00 -1.819116809213001e+00 -1.821054504262256e+00 -1.822989238142106e+00 + -1.824921024174149e+00 -1.826849875071642e+00 -1.828775803432498e+00 -1.830698822001605e+00 -1.832618943490715e+00 + -1.834536180332052e+00 -1.836450544855570e+00 -1.838362049261658e+00 -1.840270705693083e+00 -1.842176526191684e+00 + -1.844079522732226e+00 -1.845979707122125e+00 -1.847877091069540e+00 -1.849771686052976e+00 -1.851663503515020e+00 + -1.853552554984233e+00 -1.855438851906239e+00 -1.857322405308933e+00 -1.859203226114476e+00 -1.861081325239847e+00 + -1.862956713608023e+00 -1.864829402171162e+00 -1.866699401811557e+00 -1.868566723102871e+00 -1.870431376467943e+00 + -1.872293372034969e+00 -1.874152719980291e+00 -1.876009430967454e+00 -1.877863515541558e+00 -1.879714983286677e+00 + -1.881563843740828e+00 -1.883410107218835e+00 -1.885253783963326e+00 -1.887094883151373e+00 -1.888933413891583e+00 + -1.890769386084288e+00 -1.892602809677417e+00 -1.894433694017575e+00 -1.896262048252058e+00 -1.898087881332244e+00 + -1.899911202238771e+00 -1.901732020265218e+00 -1.903550344662578e+00 -1.905366184198560e+00 -1.907179547502340e+00 + -1.908990443132265e+00 -1.910798879695625e+00 -1.912604866066330e+00 -1.914408411061036e+00 -1.916209523000752e+00 + -1.918008210058423e+00 -1.919804480310377e+00 -1.921598341888620e+00 -1.923389803244497e+00 -1.925178872754823e+00 + -1.926965558178970e+00 -1.928749867237572e+00 -1.930531808113790e+00 -1.932311388923252e+00 -1.934088617048956e+00 + -1.935863499807747e+00 -1.937636044984464e+00 -1.939406260367225e+00 -1.941174153289245e+00 -1.942939731044444e+00 + -1.944703001224463e+00 -1.946463971324967e+00 -1.948222648160018e+00 -1.949979038559213e+00 -1.951733150095908e+00 + -1.953484990331042e+00 -1.955234566032130e+00 -1.956981883796339e+00 -1.958726950332857e+00 -1.960469772453529e+00 + -1.962210357268799e+00 -1.963948711773954e+00 -1.965684842205069e+00 -1.967418754747339e+00 -1.969150456141664e+00 + -1.970879953151972e+00 -1.972607252078582e+00 -1.974332359180596e+00 -1.976055281015821e+00 -1.977776024078765e+00 + -1.979494594312026e+00 -1.981210997612849e+00 -1.982925240248993e+00 -1.984637328483028e+00 -1.986347268186276e+00 + -1.988055065135925e+00 -1.989760725123873e+00 -1.991464254028801e+00 -1.993165658061782e+00 -1.994864943305917e+00 + -1.996562115000000e+00 -1.998257178352118e+00 -1.999950139291834e+00 -2.001641003786081e+00 -2.003329777229788e+00 + -2.005016464899233e+00 -2.006701072168050e+00 -2.008383604435580e+00 -2.010064067106614e+00 -2.011742465557514e+00 + -2.013418805045480e+00 -2.015093090790721e+00 -2.016765327984645e+00 -2.018435521788566e+00 -2.020103677272243e+00 + -2.021769799450648e+00 -2.023433893211152e+00 -2.025095963440481e+00 -2.026756015150358e+00 -2.028414053372033e+00 + -2.030070083089858e+00 -2.031724109167109e+00 -2.033376136029651e+00 -2.035026168111125e+00 -2.036674210313675e+00 + -2.038320267543339e+00 -2.039964344253219e+00 -2.041606444873179e+00 -2.043246574193053e+00 -2.044884736927830e+00 + -2.046520937133174e+00 -2.048155178894251e+00 -2.049787467073582e+00 -2.051417806490505e+00 -2.053046201014273e+00 + -2.054672654449746e+00 -2.056297171294283e+00 -2.057919756136151e+00 -2.059540413234731e+00 -2.061159146675282e+00 + -2.062775960175462e+00 -2.064390857518372e+00 -2.066003843116474e+00 -2.067614921377108e+00 -2.069224096057763e+00 + -2.070831370870978e+00 -2.072436749999330e+00 -2.074040237602111e+00 -2.075641837275425e+00 -2.077241552544816e+00 + -2.078839387216755e+00 -2.080435345153352e+00 -2.082029430158359e+00 -2.083621645967183e+00 -2.085211996100236e+00 + -2.086800484128769e+00 -2.088387114042385e+00 -2.089971889736969e+00 -2.091554814315162e+00 -2.093135890870968e+00 + -2.094715123257078e+00 -2.096292515329556e+00 -2.097868070199266e+00 -2.099441790929908e+00 -2.101013681141721e+00 + -2.102583744473837e+00 -2.104151984084442e+00 -2.105718403103298e+00 -2.107283005027429e+00 -2.108845793364375e+00 + -2.110406771296459e+00 -2.111965941910842e+00 -2.113523308239219e+00 -2.115078873308544e+00 -2.116632640182243e+00 + -2.118184611994434e+00 -2.119734792125529e+00 -2.121283183887100e+00 -2.122829790069075e+00 -2.124374613416041e+00 + -2.125917657012881e+00 -2.127458923984833e+00 -2.128998417278243e+00 -2.130536139767974e+00 -2.132072094221826e+00 + -2.133606283403289e+00 -2.135138710165668e+00 -2.136669377406417e+00 -2.138198288109766e+00 -2.139725445172409e+00 + -2.141250851054121e+00 -2.142774508270670e+00 -2.144296419998729e+00 -2.145816589318136e+00 -2.147335018260493e+00 + -2.148851708859426e+00 -2.150366664204882e+00 -2.151879887475646e+00 -2.153391381149525e+00 -2.154901147551277e+00 + -2.156409189094421e+00 -2.157915508301146e+00 -2.159420108039566e+00 -2.160922991060322e+00 -2.162424159298261e+00 + -2.163923614721020e+00 -2.165421360243191e+00 -2.166917398765767e+00 -2.168411732188371e+00 -2.169904362385663e+00 + -2.171395292133801e+00 -2.172884524283159e+00 -2.174372061079477e+00 -2.175857904621596e+00 -2.177342057025400e+00 + -2.178824520458782e+00 -2.180305297280612e+00 -2.181784389836284e+00 -2.183261800226323e+00 -2.184737530553230e+00 + -2.186211583172279e+00 -2.187683960396664e+00 -2.189154664118480e+00 -2.190623696232450e+00 -2.192091059064924e+00 + -2.193556754973807e+00 -2.195020786011611e+00 -2.196483154140098e+00 -2.197943861263397e+00 -2.199402909290797e+00 + -2.200860300209873e+00 -2.202316036078389e+00 -2.203770119156592e+00 -2.205222551620105e+00 -2.206673335103553e+00 + -2.208122471221687e+00 -2.209569962050753e+00 -2.211015809743800e+00 -2.212460016299604e+00 -2.213902583604158e+00 + -2.215343513246597e+00 -2.216782806815468e+00 -2.218220466193829e+00 -2.219656493330310e+00 -2.221090890141300e+00 + -2.222523658493742e+00 -2.223954800089009e+00 -2.225384316635711e+00 -2.226812210036953e+00 -2.228238482128524e+00 + -2.229663134282465e+00 -2.231086167933421e+00 -2.232507585230206e+00 -2.233927388263609e+00 -2.235345578178182e+00 + -2.236762156112363e+00 -2.238177124126393e+00 -2.239590484325721e+00 -2.241002238074839e+00 -2.242412386688506e+00 + -2.243820932023517e+00 -2.245227875877045e+00 -2.246633219265731e+00 -2.248036963296034e+00 -2.249439110214208e+00 + -2.250839662216949e+00 -2.252238620162919e+00 -2.253635984842608e+00 -2.255031758111861e+00 -2.256425941987018e+00 + -2.257818538061035e+00 -2.259209547728066e+00 -2.260598972010440e+00 -2.261986811976363e+00 -2.263373069249392e+00 + -2.264757745520950e+00 -2.266140842198597e+00 -2.267522360622610e+00 -2.268902302148032e+00 -2.270280668153553e+00 + -2.271657460097697e+00 -2.273032679375423e+00 -2.274406327047590e+00 -2.275778404191426e+00 -2.277148912283742e+00 + -2.278517852852843e+00 -2.279885227233438e+00 -2.281251036662961e+00 -2.282615282183361e+00 -2.283977964870765e+00 + -2.285339086133513e+00 -2.286698647429660e+00 -2.288056650083893e+00 -2.289413095312870e+00 -2.290767984034498e+00 + -2.292121317209354e+00 -2.293473096267451e+00 -2.294823322630535e+00 -2.296171997217860e+00 -2.297519120939147e+00 + -2.298864695168495e+00 -2.300208721271999e+00 -2.301551200119357e+00 -2.302892132586471e+00 -2.304231520070443e+00 + -2.305569363951571e+00 -2.306905665021753e+00 -2.308240424043668e+00 -2.309573642251534e+00 -2.310905320943594e+00 + -2.312235461202651e+00 -2.313564064009707e+00 -2.314891130153991e+00 -2.316216660462560e+00 -2.317540656105554e+00 + -2.318863118293744e+00 -2.320184048057342e+00 -2.321503446385586e+00 -2.322821314284393e+00 -2.324137652689092e+00 + -2.325452462235987e+00 -2.326765743634779e+00 -2.328077498187803e+00 -2.329387727168217e+00 -2.330696431139842e+00 + -2.332003610675342e+00 -2.333309267092103e+00 -2.334613401701304e+00 -2.335916015044585e+00 -2.337217107588464e+00 + -2.338516680268511e+00 -2.339814734134101e+00 -2.341111270220800e+00 -2.342406289434137e+00 -2.343699792173311e+00 + -2.344991778936741e+00 -2.346282251126043e+00 -2.347571210092017e+00 -2.348858656078995e+00 -2.350144589310363e+00 + -2.351429011032167e+00 -2.352711922533504e+00 -2.353993324252988e+00 -2.355273216536063e+00 -2.356551600205969e+00 + -2.357828476165661e+00 -2.359103845159169e+00 -2.360377707896761e+00 -2.361650065112589e+00 -2.362920917562625e+00 + -2.364190266066228e+00 -2.365458111389245e+00 -2.366724454020086e+00 -2.367989294422349e+00 -2.369252633237819e+00 + -2.370514471195048e+00 -2.371774809191487e+00 -2.373033648052395e+00 -2.374290988145372e+00 -2.375546829856004e+00 + -2.376801174099476e+00 -2.378054021758188e+00 -2.379305373053798e+00 -2.380555228228685e+00 -2.381803588268867e+00 + -2.383050454170042e+00 -2.384295826222999e+00 -2.385539704659158e+00 -2.386782090177350e+00 -2.388022983519428e+00 + -2.389262385131917e+00 -2.390500295440986e+00 -2.391736715086700e+00 -2.392971644747536e+00 -2.394205085041701e+00 + -2.395437036486230e+00 -2.396667499253712e+00 -2.397896473568759e+00 -2.399123960208524e+00 -2.400349959968320e+00 + -2.401574473163553e+00 -2.402797500049246e+00 -2.404019041118798e+00 -2.405239096931802e+00 -2.406457668074259e+00 + -2.407674755052769e+00 -2.408890358029935e+00 -2.410104477201394e+00 -2.411317113238899e+00 -2.412528266823138e+00 + -2.413737938194389e+00 -2.414946127524263e+00 -2.416152835150093e+00 -2.417358061488310e+00 -2.418561807106014e+00 + -2.419764072540869e+00 -2.420964858062149e+00 -2.422164163883997e+00 -2.423361990268478e+00 -2.424558337539998e+00 + -2.425753206224426e+00 -2.426946596778449e+00 -2.428138509180588e+00 -2.429328943436301e+00 -2.430517900136966e+00 + -2.431705379929064e+00 -2.432891383093559e+00 -2.434075909789072e+00 -2.435258960050367e+00 -2.436440534002261e+00 + -2.437620632253666e+00 -2.438799255363957e+00 -2.439976403210287e+00 -2.441152075652963e+00 -2.442326273167121e+00 + -2.443498996281469e+00 -2.444670245124171e+00 -2.445840019720089e+00 -2.447008320081434e+00 -2.448175146330043e+00 + -2.449340499038912e+00 -2.450504378726154e+00 -2.451666785239187e+00 -2.452827718349615e+00 -2.453987178196479e+00 + -2.455145165027037e+00 -2.456301679153984e+00 -2.457456720843679e+00 -2.458610290111703e+00 -2.459762386895362e+00 + -2.460913011069636e+00 -2.462062162618941e+00 -2.463209842027783e+00 -2.464356049701044e+00 -2.465500785225038e+00 + -2.466644048210323e+00 -2.467785839182998e+00 -2.468926158651886e+00 -2.470065006141172e+00 -2.471202381154697e+00 + -2.472338284099561e+00 -2.473472715451581e+00 -2.474605675058163e+00 -2.475737162666682e+00 -2.476867178252799e+00 + -2.477995721814551e+00 -2.479122793211214e+00 -2.480248392312651e+00 -2.481372519169843e+00 -2.482495173828069e+00 + -2.483616356128687e+00 -2.484736065895716e+00 -2.485854303087743e+00 -2.486971067738408e+00 -2.488086360047014e+00 + -2.489200180083995e+00 -2.490312527238630e+00 -2.491423400907520e+00 -2.492532801197714e+00 -2.493640728315912e+00 + -2.494747182157012e+00 -2.495852162518061e+00 -2.496955669116524e+00 -2.498057701682506e+00 -2.499158260076250e+00 + -2.500257344205291e+00 -2.501354954036191e+00 -2.502451089487258e+00 -2.503545750224782e+00 -2.504638935878569e+00 + -2.505730646184535e+00 -2.506820880947837e+00 -2.507909640144502e+00 -2.508996923692245e+00 -2.510082731104683e+00 + -2.511167061905791e+00 -2.512249916065080e+00 -2.513331293568936e+00 -2.514411194025691e+00 -2.515489616993924e+00 + -2.516566562211253e+00 -2.517642029416175e+00 -2.518716018171676e+00 -2.519788528087044e+00 -2.520859559132313e+00 + -2.521929111272669e+00 -2.522997184093166e+00 -2.524063777123772e+00 -2.525128890054233e+00 -2.526192522577199e+00 + -2.527254674237163e+00 -2.528315344566595e+00 -2.529374533198041e+00 -2.530432239809303e+00 -2.531488464159136e+00 + -2.532543206017777e+00 -2.533596465120445e+00 -2.534648241083385e+00 -2.535698533081969e+00 -2.536747340380982e+00 + -2.537794663043710e+00 -2.538840501172024e+00 -2.539884854223596e+00 -2.540927721482817e+00 -2.541969102185147e+00 + -2.543008995720672e+00 -2.544047402146914e+00 -2.545084321505733e+00 -2.546119753108897e+00 -2.547153696148885e+00 + -2.548186150071097e+00 -2.549217114438763e+00 -2.550246589033513e+00 -2.551274573561718e+00 -2.552301067210345e+00 + -2.553326069170913e+00 -2.554349579172571e+00 -2.555371597001575e+00 -2.556392122135012e+00 -2.557411153995589e+00 + -2.558428692097672e+00 -2.559444735964176e+00 -2.560459285060548e+00 -2.561472338773803e+00 -2.562483896234721e+00 + -2.563493956701396e+00 -2.564502520197407e+00 -2.565509586690590e+00 -2.566515155160310e+00 -2.567519224484451e+00 + -2.568521794123430e+00 -2.569522863722881e+00 -2.570522433086768e+00 -2.571520501879673e+00 -2.572517069050324e+00 + -2.573512133570669e+00 -2.574505695221420e+00 -2.575497753777856e+00 -2.576488308184784e+00 -2.577477357385580e+00 + -2.578464901148367e+00 -2.579450939304331e+00 -2.580435471112168e+00 -2.581418495678755e+00 -2.582400012076188e+00 + -2.583380019545771e+00 -2.584358518040427e+00 -2.585335507388502e+00 -2.586310986208430e+00 -2.587284953146766e+00 + -2.588257408172476e+00 -2.589228351266687e+00 -2.590197781136742e+00 -2.591165696464199e+00 -2.592132097101227e+00 + -2.593096982965479e+00 -2.594060353065933e+00 -2.595022206300420e+00 -2.595982542030859e+00 -2.596941359648237e+00 + -2.597898658195753e+00 -2.598854436786441e+00 -2.599808695160485e+00 -2.600761432999720e+00 -2.601712649125437e+00 + -2.602662342322502e+00 -2.603610512090611e+00 -2.604557157983472e+00 -2.605502279056006e+00 -2.606445874333086e+00 + -2.607387943218189e+00 -2.608328485131743e+00 -2.609267499183389e+00 -2.610204984445080e+00 -2.611140940148811e+00 + -2.612075365584592e+00 -2.613008260114454e+00 -2.613939623006402e+00 -2.614869453080320e+00 -2.615797749224179e+00 + -2.616724511046408e+00 -2.617649738126216e+00 -2.618573429205448e+00 -2.619495583026503e+00 -2.620416199171340e+00 + -2.621335277249019e+00 -2.622252816137456e+00 -2.623168814653865e+00 -2.624083272103795e+00 -2.624996187859330e+00 + -2.625907561070358e+00 -2.626817390806325e+00 -2.627725676037143e+00 -2.628632415761536e+00 -2.629537609193020e+00 + -2.630441255587996e+00 -2.631343354159609e+00 -2.632243904045731e+00 -2.633142904126422e+00 -2.634040353337229e+00 + -2.634936251093461e+00 -2.635830596765059e+00 -2.636723389060725e+00 -2.637614626713354e+00 -2.638504309213838e+00 + -2.639392436080191e+00 -2.640279006180904e+00 -2.641164018251881e+00 -2.642047471148195e+00 -2.642929363899640e+00 + -2.643809696115713e+00 -2.644688467316341e+00 -2.645565676083456e+00 -2.646441320932559e+00 -2.647315401051427e+00 + -2.648187915755844e+00 -2.649058864201336e+00 -2.649928245427330e+00 -2.650796058169106e+00 -2.651662301248424e+00 + -2.652526974137104e+00 -2.653390076247662e+00 -2.654251606105329e+00 -2.655111562238285e+00 -2.655969944073783e+00 + -2.656826751086593e+00 -2.657681982042466e+00 -2.658535635661370e+00 -2.659387711189145e+00 -2.660238207837736e+00 + -2.661087124157626e+00 -2.661934458755756e+00 -2.662780211126336e+00 -2.663624380741185e+00 -2.664466966095276e+00 + -2.665307965694397e+00 -2.666147379064445e+00 -2.666985205710447e+00 -2.667821444033845e+00 -2.668656092405469e+00 + -2.669489150177272e+00 -2.670320616801000e+00 -2.671150491146469e+00 -2.671978771965001e+00 -2.672805458115896e+00 + -2.673630548501148e+00 -2.674454042085555e+00 -2.675275937884819e+00 -2.676096235055446e+00 -2.676914932653945e+00 + -2.677732029196031e+00 -2.678547523253807e+00 -2.679361414165717e+00 -2.680173701269736e+00 -2.680984383135636e+00 + -2.681793458321363e+00 -2.682600926105787e+00 -2.683406785794135e+00 -2.684211036076172e+00 -2.685013675548027e+00 + -2.685814703046789e+00 -2.686614117528503e+00 -2.687411918184072e+00 -2.688208104155523e+00 -2.689002674154484e+00 + -2.689795626844247e+00 -2.690586961125131e+00 -2.691376675931391e+00 -2.692164770096012e+00 -2.692951242468673e+00 + -2.693736092067127e+00 -2.694519317933390e+00 -2.695300919038479e+00 -2.696080894259941e+00 -2.696859242172434e+00 + -2.697635961409562e+00 -2.698411051143577e+00 -2.699184510529523e+00 -2.699956338114957e+00 -2.700726532498006e+00 + -2.701495093086574e+00 -2.702262019208106e+00 -2.703027309058428e+00 -2.703790960874505e+00 -2.704552974189474e+00 + -2.705313348537555e+00 -2.706072082161119e+00 -2.706829173257158e+00 -2.707584621133000e+00 -2.708338425191227e+00 + -2.709090584105120e+00 -2.709841096442358e+00 -2.710589961077480e+00 -2.711337176962203e+00 -2.712082743050078e+00 + -2.712826658235913e+00 -2.713568921177743e+00 -2.714309530527581e+00 -2.715048485150131e+00 -2.715785783993005e+00 + -2.716521426122757e+00 -2.717255410569124e+00 -2.717987736095623e+00 -2.718718401385704e+00 -2.719447405068731e+00 + -2.720174745881186e+00 -2.720900423042079e+00 -2.721624435690877e+00 -2.722346782166338e+00 -2.723067460855530e+00 + -2.723786471139474e+00 -2.724503812410580e+00 -2.725219483112852e+00 -2.725933481634188e+00 -2.726645807086471e+00 + -2.727356458650697e+00 -2.728065435060333e+00 -2.728772734953498e+00 -2.729478357034439e+00 -2.730182300087997e+00 + -2.730884563155262e+00 -2.731585145263588e+00 -2.732284045129153e+00 -2.732981261442558e+00 -2.733676793103288e+00 + -2.734370639038562e+00 -2.735062798077667e+00 -2.735753269071118e+00 -2.736442051052291e+00 -2.737129142959769e+00 + -2.737814543170111e+00 -2.738498250131983e+00 -2.739180263144520e+00 -2.739860581563291e+00 -2.740539204119172e+00 + -2.741216129405992e+00 -2.741891356094071e+00 -2.742564882952538e+00 -2.743236709069217e+00 -2.743906833523784e+00 + -2.744575255044610e+00 -2.745241972311204e+00 -2.745906984158941e+00 -2.746570289467025e+00 -2.747231887134115e+00 + -2.747891776057501e+00 -2.748549955109537e+00 -2.749206423158993e+00 -2.749861179085207e+00 -2.750514221765824e+00 + -2.751165550061125e+00 -2.751815162841771e+00 -2.752463059037292e+00 -2.753109237554207e+00 -2.753753697148108e+00 + -2.754396436622574e+00 -2.755037455124055e+00 -2.755676751755156e+00 -2.756314325100252e+00 -2.756950173779785e+00 + -2.757584297076699e+00 -2.758216694281619e+00 -2.758847364053396e+00 -2.759476305000437e+00 -2.760103516161140e+00 + -2.760728996610216e+00 -2.761352745137616e+00 -2.761974760563591e+00 -2.762595042114344e+00 -2.763213589016364e+00 + -2.763830400091322e+00 -2.764445474113015e+00 -2.765058810068553e+00 -2.765670407011266e+00 -2.766280264046035e+00 + -2.766888380201558e+00 -2.767494754150214e+00 -2.768099384646222e+00 -2.768702271127474e+00 -2.769303413030783e+00 + -2.769902809104988e+00 -2.770500458053093e+00 -2.771096359082754e+00 -2.771690511445131e+00 -2.772282914060774e+00 + -2.772873565847032e+00 -2.773462466039048e+00 -2.774049613856528e+00 -2.774635008139637e+00 -2.775218647762881e+00 + -2.775800532117688e+00 -2.776380660598635e+00 -2.776959032095993e+00 -2.777535645483684e+00 -2.778110500074552e+00 + -2.778683595228330e+00 -2.779254930053368e+00 -2.779824503611819e+00 -2.780392315032438e+00 -2.780958363471580e+00 + -2.781522648129417e+00 -2.782085168237396e+00 -2.782645923108263e+00 -2.783204912027138e+00 -2.783762134087364e+00 + -2.784317588365996e+00 -2.784871274066723e+00 -2.785423190471204e+00 -2.785973337046338e+00 -2.786521713227682e+00 + -2.787068318140169e+00 -2.787613150927563e+00 -2.788156211119559e+00 -2.788697498201977e+00 -2.789237011099205e+00 + -2.789774748795882e+00 -2.790310711079109e+00 -2.790844897774500e+00 -2.791377308059270e+00 -2.791907941021321e+00 + -2.792436796039691e+00 -2.792963872575855e+00 -2.793489170129877e+00 -2.794012688183935e+00 -2.794534426110070e+00 + -2.795054383269529e+00 -2.795572559090522e+00 -2.796088953089790e+00 -2.796603565071232e+00 -2.797116394731634e+00 + -2.797627441052200e+00 -2.798136703104035e+00 -2.798644181033428e+00 -2.799149874997305e+00 -2.799653784119957e+00 + -2.800155907491874e+00 -2.800656245100958e+00 -2.801154796934787e+00 -2.801651562082218e+00 -2.802146539693571e+00 + -2.802639730063738e+00 -2.803131133478864e+00 -2.803620749045517e+00 -2.804108575856467e+00 -2.804594614128865e+00 + -2.805078864118387e+00 -2.805561325110418e+00 -2.806041996375143e+00 -2.806520878092229e+00 -2.806997970489045e+00 + -2.807473273074300e+00 -2.807946785293329e+00 -2.808418507056632e+00 -2.808888438355500e+00 -2.809356579039224e+00 + -2.809822928959404e+00 -2.810287488118900e+00 -2.810750256531227e+00 -2.811211234101264e+00 -2.811670420689050e+00 + -2.812127816083888e+00 -2.812583420143096e+00 -2.813037233066774e+00 -2.813489255065615e+00 -2.813939486049919e+00 + -2.814387925944586e+00 -2.814834575033324e+00 -2.815279433542374e+00 -2.815722501109326e+00 -2.816163777438837e+00 + -2.816603263092504e+00 -2.817040958671196e+00 -2.817476864075942e+00 -2.817910979131784e+00 -2.818343304059641e+00 + -2.818773839208482e+00 -2.819202585043600e+00 -2.819629541969078e+00 -2.820054710027820e+00 -2.820478089265513e+00 + -2.820899680100151e+00 -2.821319482977751e+00 -2.821737498084143e+00 -2.822153725615352e+00 -2.822568166068396e+00 + -2.822980820018520e+00 -2.823391688052908e+00 -2.823800770674544e+00 -2.824208068037681e+00 -2.824613580315654e+00 + -2.825017308106835e+00 -2.825419252121360e+00 -2.825819413091381e+00 -2.826217791658008e+00 -2.826614388076187e+00 + -2.827009202624378e+00 -2.827402236061253e+00 -2.827793489256864e+00 -2.828182963046578e+00 -2.828570658171722e+00 + -2.828956575032161e+00 -2.829340714052488e+00 -2.829723076097664e+00 -2.830103662132774e+00 -2.830482473083023e+00 + -2.830859509823491e+00 -2.831234773068641e+00 -2.831608263528317e+00 -2.831979982054516e+00 -2.832349929557777e+00 + -2.832718107040651e+00 -2.833084515526141e+00 -2.833449156027042e+00 -2.833812029550204e+00 -2.834173137088914e+00 + -2.834532479620883e+00 -2.834890058075082e+00 -2.835245873448821e+00 -2.835599927061508e+00 -2.835952220243667e+00 + -2.836302754048190e+00 -2.836651529530672e+00 -2.836998548035129e+00 -2.837343810883671e+00 -2.837687319022324e+00 + -2.838029073490917e+00 -2.838369076080591e+00 -2.838707328586376e+00 -2.839043832067564e+00 -2.839378587474163e+00 + -2.839711596054793e+00 -2.840042859259108e+00 -2.840372379042276e+00 -2.840700157280677e+00 -2.841026195030013e+00 + -2.841350493343512e+00 -2.841673054085180e+00 -2.841993879190829e+00 -2.842312970072699e+00 -2.842630328108386e+00 + -2.842945955060471e+00 -2.843259852775203e+00 -2.843572023048496e+00 -2.843882467617769e+00 -2.844191188036773e+00 + -2.844498185884593e+00 -2.844803463025301e+00 -2.845107021413000e+00 -2.845408863076932e+00 -2.845708990020076e+00 + -2.846007404065244e+00 -2.846304107050338e+00 -2.846599101053807e+00 -2.846892388135785e+00 -2.847183970042619e+00 + -2.847473848570861e+00 -2.847762026031680e+00 -2.848048504803730e+00 -2.848333287020989e+00 -2.848616374754612e+00 + -2.848897770069131e+00 -2.849177475073159e+00 -2.849455492058227e+00 -2.849731823327478e+00 -2.850006471047571e+00 + -2.850279437434387e+00 -2.850550725037162e+00 -2.850820336439234e+00 -2.851088274026996e+00 -2.851354540133094e+00 + -2.851619137072155e+00 -2.851882067200814e+00 -2.852143333061782e+00 -2.852402937208544e+00 -2.852660882051651e+00 + -2.852917170055367e+00 -2.853171804041764e+00 -2.853424786850297e+00 -2.853676121032120e+00 -2.853925809140160e+00 + -2.854173854022716e+00 -2.854420258509995e+00 -2.854665025064492e+00 -2.854908156206457e+00 -2.855149655054884e+00 + -2.855389524765914e+00 -2.855627768045515e+00 -2.855864387531145e+00 -2.856099386036384e+00 -2.856332766480263e+00 + -2.856564532027491e+00 -2.856794685864488e+00 -2.857023231018833e+00 -2.857250170456676e+00 -2.857475507057297e+00 + -2.857699243787178e+00 -2.857921384048440e+00 -2.858141931205942e+00 -2.858360888039817e+00 -2.858578257403886e+00 + -2.858794043031427e+00 -2.859008248642304e+00 -2.859220877023269e+00 -2.859431930941042e+00 -2.859641414015340e+00 + -2.859849329964776e+00 -2.860055682050569e+00 -2.860260473522559e+00 -2.860463708042447e+00 -2.860665389218646e+00 + -2.860865520034553e+00 -2.861064103583913e+00 -2.861261144026887e+00 -2.861456645505078e+00 -2.861650611019446e+00 + -2.861843043539793e+00 -2.862033947051935e+00 -2.862223325674870e+00 -2.862411183044306e+00 -2.862597522669464e+00 + -2.862782348036900e+00 -2.862965662765951e+00 -2.863147471029718e+00 -2.863327776966641e+00 -2.863506584022756e+00 + -2.863683895649960e+00 -2.863859716016013e+00 -2.864034049304372e+00 -2.864206899045429e+00 -2.864378268816853e+00 + -2.864548163038503e+00 -2.864716586175495e+00 -2.864883542031795e+00 -2.865049034317118e+00 -2.865213067025303e+00 + -2.865375644227383e+00 -2.865536770019026e+00 -2.865696448531390e+00 -2.865854684012960e+00 -2.866011480747103e+00 + -2.866166843039399e+00 -2.866320775137251e+00 -2.866473281033156e+00 -2.866624364792500e+00 -2.866774031027124e+00 + -2.866922284373643e+00 -2.867069129021301e+00 -2.867214569108258e+00 -2.867358609015685e+00 -2.867501253183005e+00 + -2.867642506039625e+00 -2.867782372075631e+00 -2.867920856033839e+00 -2.868057962606175e+00 -2.868193696028257e+00 + -2.868328060561013e+00 -2.868461061022879e+00 -2.868592702303233e+00 -2.868722989017701e+00 -2.868851925722842e+00 + -2.868979517012722e+00 -2.869105767524959e+00 -2.869230682033886e+00 -2.869354265317122e+00 -2.869476522028743e+00 + -2.869597456891174e+00 -2.869717075023798e+00 -2.869835381525858e+00 -2.869952381019048e+00 -2.870068078133983e+00 + -2.870182478014490e+00 -2.870295585788873e+00 -2.870407406010122e+00 -2.870517943287246e+00 -2.870627203028626e+00 + -2.870735190678368e+00 -2.870841911024103e+00 -2.870947368779615e+00 -2.871051569019769e+00 -2.871154516959833e+00 + -2.871256218015620e+00 -2.871356677487263e+00 -2.871455900011655e+00 -2.871553890297982e+00 -2.871650654007871e+00 + -2.871746196881877e+00 -2.871840524023838e+00 -2.871933640394619e+00 -2.872025551019907e+00 -2.872116261043417e+00 + -2.872205776016155e+00 -2.872294101539941e+00 -2.872381243012580e+00 -2.872467205758066e+00 -2.872551995009178e+00 + -2.872635615995248e+00 -2.872718074023048e+00 -2.872799374482606e+00 -2.872879523019508e+00 -2.872958525324841e+00 + -2.873036387016140e+00 -2.873113113575017e+00 -2.873188710012942e+00 -2.873263181462381e+00 -2.873336534009911e+00 + -2.873408773769060e+00 -2.873479906007045e+00 -2.873549935889074e+00 -2.873618869018622e+00 -2.873686711126628e+00 + -2.873753468015626e+00 -2.873819145455355e+00 -2.873883749012791e+00 -2.873947284262238e+00 -2.874009757010115e+00 + -2.874071173064448e+00 -2.874131538007598e+00 -2.874190857408149e+00 -2.874249137005235e+00 -2.874306382592947e+00 + -2.874362600014657e+00 -2.874417795154723e+00 -2.874471974012172e+00 -2.874525142492177e+00 -2.874577306009839e+00 + -2.874628470067637e+00 -2.874678641007656e+00 -2.874727825164796e+00 -2.874776028005620e+00 -2.874823254939239e+00 + -2.874869512013286e+00 -2.874914805384953e+00 -2.874959141011137e+00 -2.875002524843012e+00 -2.875044963009132e+00 + -2.875086461553842e+00 -2.875127026007268e+00 -2.875166661990855e+00 -2.875205376005544e+00 -2.875243174521211e+00 + -2.875280063003956e+00 -2.875316046953741e+00 -2.875351133009737e+00 -2.875385327829893e+00 -2.875418637008044e+00 + -2.875451066029114e+00 -2.875482621006486e+00 -2.875513308222273e+00 -2.875543134005058e+00 -2.875572104616458e+00 + -2.875600226003760e+00 -2.875627504088381e+00 -2.875653945002586e+00 -2.875679554924722e+00 -2.875704340006628e+00 + -2.875728306365356e+00 -2.875751460005359e+00 -2.875773807024162e+00 -2.875795354004213e+00 -2.875816107441742e+00 + -2.875836073003188e+00 -2.875855256356105e+00 -2.875873664002281e+00 -2.875891302525273e+00 -2.875908178001488e+00 + -2.875924296429527e+00 -2.875939664003940e+00 -2.875954287022889e+00 -2.875968172003060e+00 -2.875981325374513e+00 + -2.875993753002293e+00 -2.876005460745149e+00 -2.876016455001635e+00 -2.876026742281703e+00 -2.876036329001085e+00 + -2.876045221511428e+00 -2.876053426002279e+00 -2.876060948682664e+00 -2.876067796001651e+00 -2.876073974394489e+00 + -2.876079490001126e+00 -2.876084348997735e+00 -2.876088558000703e+00 -2.876092123620084e+00 -2.876095052000378e+00 + -2.876097349275196e+00 -2.876099022000147e+00 -2.876100076780735e+00 -2.876100520000039e+00 -2.876100357977497e+00 + -2.876099597000405e+00 -2.876098243435337e+00 -2.876096303998139e+00 -2.876093785401991e+00 -2.876090694000126e+00 + -2.876087036076098e+00 -2.876082817994697e+00 -2.876078046153286e+00 -2.876072726998279e+00 -2.876066867041051e+00 + -2.876060473003754e+00 -2.876053551562065e+00 -2.876046108994973e+00 -2.876038151582050e+00 -2.876029686001908e+00 + -2.876020718975022e+00 -2.876011256990315e+00 -2.876001306494705e+00 -2.875990873998654e+00 -2.875979966015766e+00 + -2.875968589008655e+00 -2.875956749461299e+00 -2.875944453994101e+00 -2.875931709272467e+00 -2.875918522005370e+00 + -2.875904898821941e+00 -2.875890845988358e+00 -2.875876369796106e+00 -2.875861477000839e+00 -2.875846174460938e+00 + -2.875830468981534e+00 -2.875814367182402e+00 -2.875797874995170e+00 -2.875780998493851e+00 -2.875763745010153e+00 + -2.875746121853747e+00 -2.875728134988475e+00 -2.875709790337169e+00 -2.875691095004476e+00 -2.875672056151185e+00 + -2.875652679980860e+00 -2.875632972639220e+00 -2.875612940997824e+00 -2.875592591983200e+00 -2.875571932015899e+00 + -2.875550967463832e+00 -2.875529704990307e+00 -2.875508151305197e+00 -2.875486313009207e+00 -2.875464196688727e+00 + -2.875441808982035e+00 -2.875419156538716e+00 -2.875396246001703e+00 -2.875373083982446e+00 -2.875349676973115e+00 + -2.875326031456047e+00 -2.875302153993497e+00 -2.875278051224424e+00 -2.875253730014671e+00 -2.875229197164465e+00 + -2.875204458984698e+00 -2.875179521740897e+00 -2.875154392006447e+00 -2.875129076470253e+00 -2.875103581975416e+00 + -2.875077915323747e+00 -2.875052082997684e+00 -2.875026091410789e+00 -2.874999947020509e+00 -2.874973656330889e+00 + -2.874947225988491e+00 -2.874920662667701e+00 -2.874893973011697e+00 -2.874867163623783e+00 -2.874840240978976e+00 + -2.874813211559227e+00 -2.874786082002508e+00 -2.874758858958694e+00 -2.874731548969249e+00 -2.874704158521300e+00 + -2.874676693993052e+00 -2.874649161850167e+00 -2.874621569017096e+00 -2.874593922351292e+00 -2.874566227983435e+00 + -2.874538491996276e+00 -2.874510721007613e+00 -2.874482921761722e+00 -2.874455100973768e+00 -2.874427265275985e+00 + -2.874399420998023e+00 -2.874371574431975e+00 -2.874343732022288e+00 -2.874315900299783e+00 -2.874288085988434e+00 + -2.874260295776052e+00 -2.874232536012641e+00 -2.874204812974258e+00 -2.874177132978955e+00 -2.874149502426689e+00 + -2.874121928003048e+00 -2.874094416390038e+00 -2.874066973969692e+00 -2.874039607056358e+00 -2.874012321993617e+00 + -2.873985125156578e+00 -2.873958023017241e+00 -2.873931022092817e+00 -2.873904128984454e+00 -2.873877350227203e+00 + -2.873850692007775e+00 -2.873824160475146e+00 -2.873797761975665e+00 -2.873771502947487e+00 -2.873745389998629e+00 + -2.873719429664607e+00 -2.873693628021065e+00 -2.873667991196405e+00 -2.873642525989910e+00 -2.873617239207638e+00 + -2.873592137011854e+00 -2.873567225478465e+00 -2.873542510981722e+00 -2.873517999984164e+00 -2.873493699003122e+00 + -2.873469614539558e+00 -2.873445752974173e+00 -2.873422120664412e+00 -2.873398723994974e+00 -2.873375569341346e+00 + -2.873352663014937e+00 -2.873330011368907e+00 -2.873307620987516e+00 -2.873285498440290e+00 -2.873263650006746e+00 + -2.873242081977908e+00 -2.873220800980854e+00 -2.873199813610778e+00 -2.873179125999297e+00 -2.873158744269642e+00 + -2.873138674975094e+00 -2.873118924733721e+00 -2.873099499992696e+00 -2.873080407078925e+00 -2.873061652009151e+00 + -2.873043240951156e+00 -2.873025180987050e+00 -2.873007479104932e+00 -2.872990141002529e+00 -2.872973172348110e+00 + -2.872956579982463e+00 -2.872940370832477e+00 -2.872924550996914e+00 -2.872909126514257e+00 -2.872894104009989e+00 + -2.872879490127201e+00 -2.872865290992410e+00 -2.872851512733995e+00 -2.872838162004323e+00 -2.872825245427317e+00 + -2.872812768989124e+00 -2.872800738661925e+00 -2.872789160999820e+00 -2.872778042642130e+00 -2.872767389987160e+00 + -2.872757209355336e+00 -2.872747506996586e+00 -2.872738289140315e+00 -2.872729562004331e+00 -2.872721331833777e+00 + -2.872713604994726e+00 -2.872706387896571e+00 -2.872699687001068e+00 -2.872693508692679e+00 -2.872687858994343e+00 + -2.872682743943764e+00 -2.872678169999229e+00 -2.872674143639194e+00 -2.872670671002211e+00 -2.872667758252759e+00 + -2.872665411998920e+00 -2.872663638727966e+00 -2.872662444000314e+00 -2.872661833458480e+00 -2.872661814000242e+00 + -2.872662392564575e+00 -2.872663574999996e+00 -2.872665367034357e+00 -2.872667775003300e+00 -2.872670805307676e+00 + -2.872674464001362e+00 -2.872678757122995e+00 -2.872683690997219e+00 -2.872689271947241e+00 -2.872695506004511e+00 + -2.872702399218003e+00 -2.872709957998547e+00 -2.872718188690384e+00 -2.872727097009549e+00 -2.872736688669513e+00 + -2.872746970001709e+00 -2.872757947412680e+00 -2.872769626991446e+00 -2.872782014787135e+00 -2.872795117006809e+00 + -2.872808939808297e+00 -2.872823488994544e+00 -2.872838770359238e+00 -2.872854790013944e+00 -2.872871554154958e+00 + -2.872889068999627e+00 -2.872907340687168e+00 -2.872926375023218e+00 -2.872946177789640e+00 -2.872966755006795e+00 + -2.872988112738970e+00 -2.873010256987659e+00 -2.873033193743455e+00 -2.873056929016149e+00 -2.873081468798353e+00 + -2.873106818994782e+00 -2.873132985471494e+00 -2.873159974027786e+00 -2.873187790508094e+00 -2.873216441004140e+00 + -2.873245931584463e+00 -2.873276267977569e+00 -2.873307455856915e+00 -2.873339501015828e+00 -2.873372409342765e+00 + -2.873406186986854e+00 -2.873440840030674e+00 -2.873476374029945e+00 -2.873512794459630e+00 -2.873550106998518e+00 + -2.873588317466817e+00 -2.873627432046586e+00 -2.873667456808100e+00 -2.873708397012657e+00 -2.873750257967860e+00 + -2.873793045975522e+00 -2.873836767295967e+00 -2.873881427029366e+00 -2.873927030237608e+00 -2.873973582989610e+00 + -2.874021091436191e+00 -2.874069561048740e+00 -2.874118997257345e+00 -2.874169406006314e+00 -2.874220793186470e+00 + -2.874273163960479e+00 -2.874326523535612e+00 -2.874380878025728e+00 -2.874436233504353e+00 -2.874492594977105e+00 + -2.874549967456173e+00 -2.874608357047944e+00 -2.874667769870749e+00 -2.874728210996486e+00 -2.874789685444839e+00 + -2.874852199073056e+00 -2.874915757808161e+00 -2.874980367018717e+00 -2.875046031956011e+00 -2.875112757960702e+00 + -2.875180550448241e+00 -2.875249415043884e+00 -2.875319357389408e+00 -2.875390382982873e+00 -2.875462497200150e+00 + -2.875535705072081e+00 -2.875610011724477e+00 -2.875685423008027e+00 -2.875761944747628e+00 -2.875839581940104e+00 + -2.875918339524430e+00 -2.875998223036253e+00 -2.876079238083328e+00 -2.876161389965175e+00 -2.876244683897332e+00 + -2.876329125067640e+00 -2.876414718675390e+00 -2.876501469993362e+00 -2.876589384334920e+00 -2.876678467102276e+00 + -2.876768723646439e+00 -2.876860159024752e+00 -2.876952778311590e+00 -2.877046586943105e+00 -2.877141590285005e+00 + -2.877237793059432e+00 -2.877335200055582e+00 -2.877433816974432e+00 -2.877533649470098e+00 -2.877634702097487e+00 + -2.877736979404358e+00 -2.877840487009089e+00 -2.877945230580227e+00 -2.878051214916385e+00 -2.878158444703550e+00 + -2.878266925047163e+00 -2.878376661120778e+00 -2.878487657950954e+00 -2.878599920558564e+00 -2.878713454088738e+00 + -2.878828263638601e+00 -2.878944353988982e+00 -2.879061729871082e+00 -2.879180396133895e+00 -2.879300357745253e+00 + -2.879421620030550e+00 -2.879544188234639e+00 -2.879668066922659e+00 -2.879793260582870e+00 -2.879919774075741e+00 + -2.880047612428619e+00 -2.880176780964157e+00 -2.880307284823274e+00 -2.880439128124635e+00 -2.880572315044195e+00 + -2.880706851009318e+00 -2.880842741491739e+00 -2.880979990889281e+00 -2.881118603470176e+00 -2.881258584058220e+00 + -2.881399937594580e+00 -2.881542668934350e+00 -2.881686782880171e+00 -2.881832284110943e+00 -2.881979177270132e+00 + -2.882127466983199e+00 -2.882277157822698e+00 -2.882428254167564e+00 -2.882580760515876e+00 -2.882734682035907e+00 + -2.882890023809088e+00 -2.883046789899305e+00 -2.883204984344022e+00 -2.883364612092550e+00 -2.883525678164890e+00 + -2.883688186951939e+00 -2.883852142755886e+00 -2.884017550153203e+00 -2.884184413751485e+00 -2.884352738008543e+00 + -2.884522527349429e+00 -2.884693786217942e+00 -2.884866519029743e+00 -2.885040730069195e+00 -2.885216423722596e+00 + -2.885393604915286e+00 -2.885572278454246e+00 -2.885752448133968e+00 -2.885934117732660e+00 -2.886117291975880e+00 + -2.886301975695701e+00 -2.886488173202934e+00 -2.886675888645447e+00 -2.886865126040629e+00 -2.887055889528861e+00 + -2.887248183873006e+00 -2.887442013779875e+00 -2.887637383109605e+00 -2.887834295673936e+00 -2.888032755937675e+00 + -2.888232768417303e+00 -2.888434337182880e+00 -2.888637466267979e+00 -2.888842160006608e+00 -2.889048422705334e+00 + -2.889256258260521e+00 -2.889465670586525e+00 -2.889676664079871e+00 -2.889889243164732e+00 -2.890103411893701e+00 + -2.890319174230825e+00 -2.890536534157536e+00 -2.890755495690120e+00 -2.890976062966901e+00 -2.891198240133124e+00 + -2.891422031239666e+00 -2.891647440271526e+00 -2.891874471044534e+00 -2.892103127449178e+00 -2.892333413843735e+00 + -2.892565334531329e+00 -2.892798893126666e+00 -2.893034093211137e+00 -2.893270938921286e+00 -2.893509434394119e+00 + -2.893749583213363e+00 -2.893991388990754e+00 -2.894234856003367e+00 -2.894479988544211e+00 -2.894726790304690e+00 + -2.894975264880993e+00 -2.895225416090045e+00 -2.895477247800793e+00 -2.895730763869547e+00 -2.895985968110420e+00 + -2.896242864181383e+00 -2.896501455784724e+00 -2.896761746956156e+00 -2.897023741664482e+00 -2.897287443277443e+00 + -2.897552855132549e+00 -2.897819981047455e+00 -2.898088824960355e+00 -2.898359390811481e+00 -2.898631682423090e+00 + -2.898905703143506e+00 -2.899181456336644e+00 -2.899458945902694e+00 -2.899738175745144e+00 -2.900019149244370e+00 + -2.900301869748365e+00 -2.900586340998689e+00 -2.900872566741790e+00 -2.901160550350105e+00 -2.901450295205248e+00 + -2.901741805099525e+00 -2.902035083835090e+00 -2.902330134842785e+00 -2.902626961482952e+00 -2.902925567205262e+00 + -2.903225955501619e+00 -2.903528129943548e+00 -2.903832094083243e+00 -2.904137851315957e+00 -2.904445404943298e+00 + -2.904754758049239e+00 -2.905065913908475e+00 -2.905378876776237e+00 -2.905693650730528e+00 -2.906010238159916e+00 + -2.906328641477237e+00 -2.906648864881840e+00 -2.906970912612057e+00 -2.907294787275635e+00 -2.907620491421319e+00 + -2.907948028992455e+00 -2.908277404008211e+00 -2.908608619396449e+00 -2.908941677961907e+00 -2.909276583108139e+00 + -2.909613338320582e+00 -2.909951946813384e+00 -2.910292411733319e+00 -2.910634736228945e+00 -2.910978923497479e+00 + -2.911324976928991e+00 -2.911672899876866e+00 -2.912022695354926e+00 -2.912374366346152e+00 -2.912727916049746e+00 + -2.913083347735332e+00 -2.913440664738005e+00 -2.913799870293631e+00 -2.914160967175702e+00 -2.914523958205600e+00 + -2.914888846858668e+00 -2.915255636613397e+00 -2.915624330306910e+00 -2.915994930711883e+00 -2.916367440984558e+00 + -2.916741864289805e+00 -2.917118203443422e+00 -2.917496461287171e+00 -2.917876641115726e+00 -2.918258746264796e+00 + -2.918642779781321e+00 -2.919028744569610e+00 -2.919416643252220e+00 -2.919806478556714e+00 -2.920198253912409e+00 + -2.920591972698769e+00 -2.920987637394092e+00 -2.921385250442034e+00 -2.921784815048848e+00 -2.922186334507697e+00 + -2.922589811696789e+00 -2.922995249368979e+00 -2.923402650190686e+00 -2.923812016928122e+00 -2.924223352833133e+00 + -2.924636661116357e+00 -2.925051944337972e+00 -2.925469204994078e+00 -2.925888445974902e+00 -2.926309670222330e+00 + -2.926732880490753e+00 -2.927158079512877e+00 -2.927585270122142e+00 -2.928014455203420e+00 -2.928445637746579e+00 + -2.928878820641719e+00 -2.929314006274898e+00 -2.929751197043434e+00 -2.930190395893735e+00 -2.930631605816839e+00 + -2.931074829433217e+00 -2.931520069294359e+00 -2.931967328046430e+00 -2.932416608452995e+00 -2.932867913652596e+00 + -2.933321246608101e+00 -2.933776609204709e+00 -2.934234003435805e+00 -2.934693432805196e+00 -2.935154900804807e+00 + -2.935618409368617e+00 -2.936083960365691e+00 -2.936551556963400e+00 -2.937021202354904e+00 -2.937492898538196e+00 + -2.937966647468766e+00 -2.938442452127255e+00 -2.938920315642269e+00 -2.939400240709141e+00 -2.939882229846171e+00 + -2.940366285296803e+00 -2.940852409365155e+00 -2.941340604872910e+00 -2.941830874578781e+00 -2.942323220472084e+00 + -2.942817644603974e+00 -2.943314150042391e+00 -2.943812739919231e+00 -2.944313416605433e+00 -2.944816182292809e+00 + -2.945321039217627e+00 -2.945827989752984e+00 -2.946337036774817e+00 -2.946848183049044e+00 -2.947361430398659e+00 + -2.947876780695535e+00 -2.948394236949976e+00 -2.948913802216184e+00 -2.949435478585527e+00 -2.949959268045502e+00 + -2.950485173130951e+00 -2.951013196489051e+00 -2.951543340668991e+00 -2.952075608036040e+00 -2.952610000317780e+00 + -2.953146519451356e+00 -2.953685168849877e+00 -2.954225951787981e+00 -2.954768869510503e+00 -2.955313923227115e+00 + -2.955861116036636e+00 -2.956410451196468e+00 -2.956961930709160e+00 -2.957515556348660e+00 -2.958071330229310e+00 + -2.958629254704319e+00 -2.959189332741965e+00 -2.959751567143614e+00 -2.960315959427935e+00 -2.960882511105170e+00 + -2.961451224934558e+00 -2.962022103774683e+00 -2.962595149632548e+00 -2.963170364371659e+00 -2.963747750133120e+00 + -2.964327309260061e+00 -2.964909044626116e+00 -2.965492958892178e+00 -2.966079053337689e+00 -2.966667329311879e+00 + -2.967257789824588e+00 -2.967850437973655e+00 -2.968445275548303e+00 -2.969042304161408e+00 -2.969641526029084e+00 + -2.970242943489398e+00 -2.970846558764995e+00 -2.971452374012471e+00 -2.972060391239641e+00 -2.972670612566008e+00 + -2.973283040706606e+00 -2.973897678221620e+00 -2.974514526456296e+00 -2.975133586785449e+00 -2.975754861917081e+00 + -2.976378354633252e+00 -2.977004066679083e+00 -2.977631999719257e+00 -2.978262156133669e+00 -2.978894538388579e+00 + -2.979529148580497e+00 -2.980165988659094e+00 -2.980805060356407e+00 -2.981446365534977e+00 -2.982089906796993e+00 + -2.982735686662750e+00 -2.983383706585328e+00 -2.984033968085205e+00 -2.984686474019655e+00 -2.985341227187940e+00 + -2.985998228820469e+00 -2.986657480057624e+00 -2.987318983248517e+00 -2.987982740990944e+00 -2.988648755668708e+00 + -2.989317029403636e+00 -2.989987563483614e+00 -2.990660359350691e+00 -2.991335419897486e+00 -2.992012747963469e+00 + -2.992692344724977e+00 -2.993374211287029e+00 -2.994058350132512e+00 -2.994744763907397e+00 -2.995433454532118e+00 + -2.996124423756546e+00 -2.996817673373822e+00 -2.997513205283444e+00 -2.998211021767050e+00 -2.998911125033880e+00 + -2.999613516621449e+00 -3.000318198120732e+00 -3.001025172008281e+00 -3.001734440748973e+00 -3.002446005875424e+00 + -3.003159868783688e+00 -3.003876031255844e+00 -3.004594495323234e+00 -3.005315263628241e+00 -3.006038338638268e+00 + -3.006763721509772e+00 -3.007491413411925e+00 -3.008221416875716e+00 -3.008953734497098e+00 -3.009688367770095e+00 + -3.010425318036306e+00 -3.011164587129571e+00 -3.011906177113799e+00 -3.012650090480955e+00 -3.013396329533748e+00 + -3.014144895389836e+00 -3.014895789237767e+00 -3.015649013734712e+00 -3.016404571515447e+00 -3.017162463656545e+00 + -3.017922691248400e+00 -3.018685256994897e+00 -3.019450163571901e+00 -3.020217411929727e+00 -3.020987002987051e+00 + -3.021758939261538e+00 -3.022533223477289e+00 -3.023309857585168e+00 -3.024088843221124e+00 -3.024870181534668e+00 + -3.025653873871900e+00 -3.026439922851719e+00 -3.027228331077071e+00 -3.028019099814318e+00 -3.028812230192102e+00 + -3.029607724124773e+00 -3.030405583764245e+00 -3.031205811426982e+00 -3.032008409239547e+00 -3.032813378404362e+00 + -3.033620720145768e+00 -3.034430436699938e+00 -3.035242530366928e+00 -3.036057002690514e+00 -3.036873855182042e+00 + -3.037693089979441e+00 -3.038514709166424e+00 -3.039338713983260e+00 -3.040165105664532e+00 -3.040993886265523e+00 + -3.041825058080565e+00 -3.042658623539453e+00 -3.043494584770202e+00 -3.044332942558215e+00 -3.045173697755793e+00 + -3.046016852825442e+00 -3.046862410359265e+00 -3.047710371857544e+00 -3.048560738605269e+00 -3.049413512118055e+00 + -3.050268694173960e+00 -3.051126287370169e+00 -3.051986294136892e+00 -3.052848715417321e+00 -3.053713552140092e+00 + -3.054580806662679e+00 -3.055450481419417e+00 -3.056322577723267e+00 -3.057197096839233e+00 -3.058074040961857e+00 + -3.058953412280709e+00 -3.059835212035924e+00 -3.060719441405425e+00 -3.061606102267731e+00 -3.062495196777212e+00 + -3.063386727491054e+00 -3.064280696619269e+00 -3.065177104580330e+00 -3.066075951959016e+00 -3.066977241796834e+00 + -3.067880977177860e+00 -3.068787158899685e+00 -3.069695787543252e+00 -3.070606865109353e+00 -3.071520393938529e+00 + -3.072436376310475e+00 -3.073354814200677e+00 -3.074275708428639e+00 -3.075199059975246e+00 -3.076124871622891e+00 + -3.077053146054635e+00 -3.077983883754724e+00 -3.078917085313194e+00 -3.079852753942089e+00 -3.080790892784741e+00 + -3.081731502087634e+00 -3.082674582011150e+00 -3.083620135268097e+00 -3.084568164866139e+00 -3.085518672439932e+00 + -3.086471659270948e+00 -3.087427126600947e+00 -3.088385075921834e+00 -3.089345509765843e+00 -3.090308430518810e+00 + -3.091273838940665e+00 -3.092241735746584e+00 -3.093212123098609e+00 -3.094185003484481e+00 -3.095160379247863e+00 + -3.096138252358965e+00 -3.097118623438258e+00 -3.098101493262150e+00 -3.099086864580523e+00 -3.100074740150514e+00 + -3.101065120784818e+00 -3.102058007230942e+00 -3.103053401920080e+00 -3.104051307417155e+00 -3.105051725138318e+00 + -3.106054656274756e+00 -3.107060102266563e+00 -3.108068064811119e+00 -3.109078546386035e+00 -3.110091549326776e+00 + -3.111107074619999e+00 -3.112125123273996e+00 -3.113145697732417e+00 -3.114168800386244e+00 -3.115194431980418e+00 + -3.116222593318652e+00 -3.117253287085768e+00 -3.118286516039464e+00 -3.119322281347848e+00 -3.120360583948459e+00 + -3.121401425446115e+00 -3.122444807777008e+00 -3.123490733535526e+00 -3.124539205035892e+00 -3.125590222813487e+00 + -3.126643787500575e+00 -3.127699901895779e+00 -3.128758568841378e+00 -3.129819789187914e+00 -3.130883563634097e+00 + -3.131949894263071e+00 -3.133018783446947e+00 -3.134090233329311e+00 -3.135164245759380e+00 -3.136240821637432e+00 + -3.137319962039862e+00 -3.138401669696502e+00 -3.139485947209752e+00 -3.140572795018887e+00 -3.141662213641400e+00 + -3.142754206070774e+00 -3.143848775370422e+00 -3.144945922407469e+00 -3.146045647810740e+00 -3.147147953452156e+00 + -3.148252841552866e+00 -3.149360314487843e+00 -3.150470374336312e+00 -3.151583021840677e+00 -3.152698257836541e+00 + -3.153816084869129e+00 -3.154936505573740e+00 -3.156059521236365e+00 -3.157185132934072e+00 -3.158313342257567e+00 + -3.159444151127381e+00 -3.160577562269707e+00 -3.161713578058511e+00 -3.162852198653188e+00 -3.163993424406347e+00 + -3.165137258658042e+00 -3.166283704751602e+00 -3.167432763056018e+00 -3.168584433853514e+00 -3.169738720053572e+00 + -3.170895624664928e+00 -3.172055148466089e+00 -3.173217292044841e+00 -3.174382057456326e+00 -3.175549447119023e+00 + -3.176719463437418e+00 -3.177892108465135e+00 -3.179067382866334e+00 -3.180245287430775e+00 -3.181425824840074e+00 + -3.182608997807819e+00 -3.183794807283624e+00 -3.184983254083125e+00 -3.186174340249998e+00 -3.187368068149750e+00 + -3.188564440207163e+00 -3.189763458501066e+00 -3.190965123667219e+00 -3.192169436468204e+00 -3.193376399616980e+00 + -3.194586015855556e+00 -3.195798286091764e+00 -3.197013211234878e+00 -3.198230794034108e+00 -3.199451037209393e+00 + -3.200673941523666e+00 -3.201899507599942e+00 -3.203127737458575e+00 -3.204358633517069e+00 -3.205592198384193e+00 + -3.206828434306502e+00 -3.208067341890413e+00 -3.209308921829809e+00 -3.210553176808560e+00 -3.211800109598040e+00 + -3.213049721329648e+00 -3.214302012941719e+00 -3.215556986240311e+00 -3.216814643392485e+00 -3.218074987141617e+00 + -3.219338019837523e+00 -3.220603741679474e+00 -3.221872153094758e+00 -3.223143257573258e+00 -3.224417058543514e+00 + -3.225693556126080e+00 -3.226972750453261e+00 -3.228254645012327e+00 -3.229539243310538e+00 -3.230826545580160e+00 + -3.232116551831102e+00 -3.233409264458852e+00 -3.234704686394765e+00 -3.236002820328103e+00 -3.237303668413965e+00 + -3.238607230912866e+00 -3.239913508296335e+00 -3.241222503774527e+00 -3.242534220589764e+00 -3.243848659374397e+00 + -3.245165820540432e+00 -3.246485706228452e+00 -3.247808319087641e+00 -3.249133662073000e+00 -3.250461737608715e+00 + -3.251792545689908e+00 -3.253126086515263e+00 -3.254462363526813e+00 -3.255801380232294e+00 -3.257143137158927e+00 + -3.258487634736825e+00 -3.259834875988172e+00 -3.261184864013611e+00 -3.262537599635538e+00 -3.263893083453904e+00 + -3.265251317457108e+00 -3.266612304094287e+00 -3.267976046269084e+00 -3.269342546452898e+00 -3.270711804933652e+00 + -3.272083822201368e+00 -3.273458601737915e+00 -3.274836147008249e+00 -3.276216458417835e+00 -3.277599536106921e+00 + -3.278985382214368e+00 -3.280373999474050e+00 -3.281765391001240e+00 -3.283159559381294e+00 -3.284556504698475e+00 + -3.285956227223949e+00 -3.287358730477579e+00 -3.288764018003004e+00 -3.290172090190266e+00 -3.291582947391597e+00 + -3.292996592961586e+00 -3.294413030263101e+00 -3.295832259689772e+00 -3.297254281509102e+00 -3.298679098453292e+00 + -3.300106713632883e+00 -3.301537129207062e+00 -3.302970346938195e+00 -3.304406367952729e+00 -3.305845193592728e+00 + -3.307286826698660e+00 -3.308731270022015e+00 -3.310178524459931e+00 -3.311628590794006e+00 -3.313081471198005e+00 + -3.314537168271639e+00 -3.315995684926260e+00 -3.317457023622331e+00 -3.318921184705128e+00 -3.320388168757214e+00 + -3.321857979425488e+00 -3.323330620242623e+00 -3.324806091220061e+00 -3.326284392457951e+00 -3.327765527932510e+00 + -3.329249501635255e+00 -3.330736313742837e+00 -3.332225964151081e+00 -3.333718455447356e+00 -3.335213790816533e+00 + -3.336711973141963e+00 -3.338213004741188e+00 -3.339716885970061e+00 -3.341223617428788e+00 -3.342733202656698e+00 + -3.344245645175923e+00 -3.345760945500658e+00 -3.347279103963591e+00 -3.348800123179309e+00 -3.350324006237700e+00 + -3.351850755847976e+00 -3.353380374190363e+00 -3.354912861709826e+00 -3.356448219173252e+00 -3.357986450370467e+00 + -3.359527558984502e+00 -3.361071545248283e+00 -3.362618409368982e+00 -3.364168154900880e+00 -3.365720785489059e+00 + -3.367276301794712e+00 -3.368834704260551e+00 -3.370395995439248e+00 -3.371960178388195e+00 -3.373527256073704e+00 + -3.375097230883950e+00 -3.376670102985606e+00 -3.378245872877927e+00 -3.379824544611959e+00 -3.381406122149057e+00 + -3.382990605539988e+00 -3.384577994855671e+00 -3.386168294158221e+00 -3.387761507524905e+00 -3.389357635102426e+00 + -3.390956676825633e+00 -3.392558635712520e+00 -3.394163515324364e+00 -3.395771318312439e+00 -3.397382046745834e+00 + -3.398995701274896e+00 -3.400612282828281e+00 -3.402231794866633e+00 -3.403854240867662e+00 -3.405479621845378e+00 + -3.407107938586081e+00 -3.408739193428916e+00 -3.410373389185216e+00 -3.412010529002203e+00 -3.413650615518111e+00 + -3.415293648999326e+00 -3.416939629995896e+00 -3.418588562564371e+00 -3.420240450691449e+00 -3.421895294577897e+00 + -3.423553094414080e+00 -3.425213854134680e+00 -3.426877577792018e+00 -3.428544266164663e+00 -3.430213919689846e+00 + -3.431886540713168e+00 -3.433562132145608e+00 -3.435240697251321e+00 -3.436922238808692e+00 -3.438606757299870e+00 + -3.440294253397158e+00 -3.441984730829699e+00 -3.443678193368453e+00 -3.445374641894819e+00 -3.447074077051543e+00 + -3.448776501416308e+00 -3.450481918039497e+00 -3.452190329927366e+00 -3.453901739641781e+00 -3.455616148011183e+00 + -3.457333556082980e+00 -3.459053967513855e+00 -3.460777385853499e+00 -3.462503811614361e+00 -3.464233245386620e+00 + -3.465965691108627e+00 -3.467701152771073e+00 -3.469439631225878e+00 -3.471181127031554e+00 -3.472925642711720e+00 + -3.474673181335264e+00 -3.476423746187027e+00 -3.478177340029919e+00 -3.479933963323171e+00 -3.481693616824597e+00 + -3.483456304790008e+00 -3.485222031388338e+00 -3.486990796943019e+00 -3.488762601570069e+00 -3.490537448401365e+00 + -3.492315341151373e+00 -3.494096282849095e+00 -3.495880275915030e+00 -3.497667321021135e+00 -3.499457419173128e+00 + -3.501250574460328e+00 -3.503046790838973e+00 -3.504846068649357e+00 -3.506648408298966e+00 -3.508453814079994e+00 + -3.510262290280344e+00 -3.512073837286068e+00 -3.513888455301771e+00 -3.515706147708129e+00 -3.517526918395819e+00 + -3.519350770119465e+00 -3.521177705073145e+00 -3.523007724344773e+00 -3.524840829328240e+00 -3.526677023747485e+00 + -3.528516311267811e+00 -3.530358692989965e+00 -3.532204169811781e+00 -3.534052744384031e+00 -3.535904419874647e+00 + -3.537759199767289e+00 -3.539617087002065e+00 -3.541478082029144e+00 -3.543342185630307e+00 -3.545209402403708e+00 + -3.547079736777425e+00 -3.548953188682862e+00 -3.550829758143615e+00 -3.552709450048714e+00 -3.554592269345012e+00 + -3.556478216345227e+00 -3.558367291032073e+00 -3.560259496702344e+00 -3.562154837300620e+00 -3.564053316048536e+00 + -3.565954935512961e+00 -3.567859696364639e+00 -3.569767599635964e+00 -3.571678649702049e+00 -3.573592850895430e+00 + -3.575510204035641e+00 -3.577430709619281e+00 -3.579354370364244e+00 -3.581281189700099e+00 -3.583211171681835e+00 + -3.585144319721653e+00 -3.587080634035166e+00 -3.589020115063184e+00 -3.590962767343901e+00 -3.592908595415016e+00 + -3.594857599714854e+00 -3.596809780701911e+00 -3.598765143014713e+00 -3.600723691343250e+00 -3.602685426403352e+00 + -3.604650348553174e+00 -3.606618460694309e+00 -3.608589766473437e+00 -3.610564269974137e+00 -3.612541974573128e+00 + -3.614522880382737e+00 -3.616506987803558e+00 -3.618494301653613e+00 -3.620484826823921e+00 -3.622478564080036e+00 + -3.624475513850586e+00 -3.626475679341938e+00 -3.628479064392689e+00 -3.630485672592619e+00 -3.632495506905407e+00 + -3.634508568039156e+00 -3.636524857004877e+00 -3.638544378280809e+00 -3.640567136287224e+00 -3.642593131745308e+00 + -3.644622365423449e+00 -3.646654841977913e+00 -3.648690566065893e+00 -3.650729538460438e+00 -3.652771759626902e+00 + -3.654817232683972e+00 -3.656865961450936e+00 -3.658917949896158e+00 -3.660973201344661e+00 -3.663031716399031e+00 + -3.665093495929850e+00 -3.667158544602091e+00 -3.669226867066577e+00 -3.671298464123134e+00 -3.673373336353373e+00 + -3.675451487317045e+00 -3.677532921173144e+00 -3.679617641499514e+00 -3.681705651197185e+00 -3.683796951041065e+00 + -3.685891542158701e+00 -3.687989429214330e+00 -3.690090616811484e+00 -3.692195105774196e+00 -3.694302896934788e+00 + -3.696413994938233e+00 -3.698528404463948e+00 -3.700646126516483e+00 -3.702767161822413e+00 -3.704891513671268e+00 + -3.707019186005269e+00 -3.709150182814482e+00 -3.711284507419287e+00 -3.713422160413482e+00 -3.715563142750310e+00 + -3.717707459547388e+00 -3.719855115839397e+00 -3.722006112164920e+00 -3.724160448777861e+00 -3.726318129289493e+00 + -3.728479158099316e+00 -3.730643539402395e+00 -3.732811276589775e+00 -3.734982370040845e+00 -3.737156820495128e+00 + -3.739334633144358e+00 -3.741515813112657e+00 -3.743700360801490e+00 -3.745888276640612e+00 -3.748079565895588e+00 + -3.750274233918474e+00 -3.752472281571475e+00 -3.754673709335501e+00 -3.756878520656135e+00 -3.759086719721971e+00 + -3.761298310728990e+00 -3.763513297133539e+00 -3.765731679426046e+00 -3.767953458457793e+00 -3.770178639489403e+00 + -3.772407227784000e+00 -3.774639224205367e+00 -3.776874629489326e+00 -3.779113448259203e+00 -3.781355685279774e+00 + -3.783601341994148e+00 -3.785850419525435e+00 -3.788102921038436e+00 -3.790358850378410e+00 -3.792618212070778e+00 + -3.794881010002580e+00 -3.797147244827153e+00 -3.799416917428862e+00 -3.801690032849888e+00 -3.803966596190487e+00 + -3.806246608625402e+00 -3.808530070983860e+00 -3.810816986638503e+00 -3.813107359693981e+00 -3.815401194639556e+00 + -3.817698495297397e+00 -3.819999262436677e+00 -3.822303497093916e+00 -3.824611204428034e+00 -3.826922389548483e+00 + -3.829237053244454e+00 -3.831555196353405e+00 -3.833876824226091e+00 -3.836201942201953e+00 -3.838530551061888e+00 + -3.840862651326505e+00 -3.843198247033778e+00 -3.845537342919513e+00 -3.847879942993476e+00 -3.850226050562932e+00 + -3.852575666851148e+00 -3.854928793361406e+00 -3.857285434801036e+00 -3.859645595950435e+00 -3.862009278678248e+00 + -3.864376484523473e+00 -3.866747216618300e+00 -3.869121478726629e+00 -3.871499275546047e+00 -3.873880611182955e+00 + -3.876265486445322e+00 -3.878653902389424e+00 -3.881045864363169e+00 -3.883441377687285e+00 -3.885840443282151e+00 + -3.888243062046155e+00 -3.890649239190073e+00 -3.893058980047241e+00 -3.895472286128841e+00 -3.897889158595383e+00 + -3.900309601026809e+00 -3.902733617656517e+00 -3.905161212912323e+00 -3.907592390603840e+00 -3.910027151873432e+00 + -3.912465498159137e+00 -3.914907434748928e+00 -3.917352966879188e+00 -3.919802095729995e+00 -3.922254822259626e+00 + -3.924711150595445e+00 -3.927171085542605e+00 -3.929634631448325e+00 -3.932101791843537e+00 -3.934572567451927e+00 + -3.937046959532740e+00 -3.939524974294695e+00 -3.942006617767883e+00 -3.944491890318428e+00 -3.946980792233828e+00 + -3.949473329151056e+00 -3.951969506957779e+00 -3.954469327195002e+00 -3.956972790971958e+00 -3.959479902017460e+00 + -3.961990664762499e+00 -3.964505083827194e+00 -3.967023163167552e+00 -3.969544903893966e+00 -3.972070307479498e+00 + -3.974599379693463e+00 -3.977132126179292e+00 -3.979668547780628e+00 -3.982208645099321e+00 -3.984752422569858e+00 + -3.987299885436030e+00 -3.989851038346246e+00 -3.992405885069993e+00 -3.994964426456437e+00 -3.997526663815754e+00 + -4.000092603222488e+00 -4.002662250581340e+00 -4.005235606353252e+00 -4.007812671084819e+00 -4.010393451108941e+00 + -4.012977952843547e+00 -4.015566177260363e+00 -4.018158124897606e+00 -4.020753800005660e+00 -4.023353207686703e+00 + -4.025956352737950e+00 -4.028563239140089e+00 -4.031173867912699e+00 -4.033788240453579e+00 -4.036406362634527e+00 + -4.039028240314873e+00 -4.041653874830120e+00 -4.044283267179555e+00 -4.046916421541453e+00 -4.049553342894448e+00 + -4.052194036239657e+00 -4.054838505774454e+00 -4.057486752458788e+00 -4.060138777601743e+00 -4.062794587146426e+00 + -4.065454187011838e+00 -4.068117578386588e+00 -4.070784762448621e+00 -4.073455745063631e+00 -4.076130532171974e+00 + -4.078809125324914e+00 -4.081491525652789e+00 -4.084177736991329e+00 -4.086867764089578e+00 -4.089561612644448e+00 + -4.092259287473573e+00 -4.094960788929582e+00 -4.097666117736884e+00 -4.100375280572002e+00 -4.103088284211306e+00 + -4.105805129878449e+00 -4.108525818267906e+00 -4.111250353510137e+00 -4.113978740671802e+00 -4.116710985128399e+00 + -4.119447091422845e+00 -4.122187060458915e+00 -4.124930893522407e+00 -4.127678597066370e+00 -4.130430177441071e+00 + -4.133185635418395e+00 -4.135944971791250e+00 -4.138708193015015e+00 -4.141475305696859e+00 -4.144246311388639e+00 + -4.147021211130915e+00 -4.149800008974389e+00 -4.152582709893380e+00 -4.155369319546537e+00 -4.158159842709882e+00 + -4.160954279944561e+00 -4.163752632239020e+00 -4.166554906505763e+00 -4.169361109687737e+00 -4.172171242925584e+00 + -4.174985306927709e+00 -4.177803306475812e+00 -4.180625247195196e+00 -4.183451134012302e+00 -4.186280970992621e+00 + -4.189114759456745e+00 -4.191952501240072e+00 -4.194794202982180e+00 -4.197639871116617e+00 -4.200489506448629e+00 + -4.203343109834506e+00 -4.206200687962978e+00 -4.209062247657938e+00 -4.211927790451525e+00 -4.214797317400862e+00 + -4.217670832954751e+00 -4.220548342457539e+00 -4.223429851444060e+00 -4.226315364591702e+00 -4.229204882957573e+00 + -4.232098408004153e+00 -4.234995946435681e+00 -4.237897504949240e+00 -4.240803084971501e+00 -4.243712687544032e+00 + -4.246626317438374e+00 -4.249543980343883e+00 -4.252465681891192e+00 -4.255391426705907e+00 -4.258321215452209e+00 + -4.261255049361277e+00 -4.264192935893713e+00 -4.267134882389568e+00 -4.270080889477248e+00 -4.273030957691918e+00 + -4.275985093907401e+00 -4.278943305249538e+00 -4.281905593513557e+00 -4.284871959946388e+00 -4.287842408932329e+00 + -4.290816945777364e+00 -4.293795576336856e+00 -4.296778305653331e+00 -4.299765134968560e+00 -4.302756065899131e+00 + -4.305751105361620e+00 -4.308750260118541e+00 -4.311753531016159e+00 -4.314760919008608e+00 -4.317772431397722e+00 + -4.320788075591533e+00 -4.323807853075197e+00 -4.326831764792573e+00 -4.329859815445223e+00 -4.332892010759197e+00 + -4.335928356800809e+00 -4.338968858700405e+00 -4.342013517504197e+00 -4.345062334602749e+00 -4.348115316848165e+00 + -4.351172471198577e+00 -4.354233799574710e+00 -4.357299303495111e+00 -4.360368987907023e+00 -4.363442858590077e+00 + -4.366520921224746e+00 -4.369603180592436e+00 -4.372689637977453e+00 -4.375780295145305e+00 -4.378875159283436e+00 + -4.381974237486932e+00 -4.385077531059527e+00 -4.388185041309383e+00 -4.391296775353732e+00 -4.394412740393244e+00 + -4.397532938153312e+00 -4.400657369887305e+00 -4.403786040435705e+00 -4.406918955633090e+00 -4.410056121703311e+00 + -4.413197543940346e+00 -4.416343223529426e+00 -4.419493162052248e+00 -4.422647366785128e+00 -4.425805845047289e+00 + -4.428968598634965e+00 -4.432135628892382e+00 -4.435306940878729e+00 -4.438482540596634e+00 -4.441662434107552e+00 + -4.444846626509031e+00 -4.448035118984182e+00 -4.451227913265940e+00 -4.454425017200977e+00 -4.457626438485681e+00 + -4.460832178101560e+00 -4.464042236947444e+00 -4.467256622306292e+00 -4.470475341701105e+00 -4.473698397230936e+00 + -4.476925790483307e+00 -4.480157526423565e+00 -4.483393610985775e+00 -4.486634050601043e+00 -4.489878850742320e+00 + -4.493128012552872e+00 -4.496381537630165e+00 -4.499639433718156e+00 -4.502901708553144e+00 -4.506168363694287e+00 + -4.509439400268067e+00 -4.512714823847340e+00 -4.515994641019672e+00 -4.519278857985080e+00 -4.522567479881829e+00 + -4.525860507988668e+00 -4.529157944122721e+00 -4.532459796114085e+00 -4.535766071688615e+00 -4.539076772142213e+00 + -4.542391898765175e+00 -4.545711459255270e+00 -4.549035461446213e+00 -4.552363907308053e+00 -4.555696798263391e+00 + -4.559034139408705e+00 -4.562375936904542e+00 -4.565722197493832e+00 -4.569072926948550e+00 -4.572428126574475e+00 + -4.575787798129616e+00 -4.579151949647104e+00 -4.582520589075836e+00 -4.585893717752653e+00 -4.589271336639746e+00 + -4.592653451812744e+00 -4.596040070428725e+00 -4.599431198857142e+00 -4.602826842289216e+00 -4.606227001990830e+00 + -4.609631679831751e+00 -4.613040884022596e+00 -4.616454622677202e+00 -4.619872897181441e+00 -4.623295708819967e+00 + -4.626723065200532e+00 -4.630154974192006e+00 -4.633591438384649e+00 -4.637032459790966e+00 -4.640478043391029e+00 + -4.643928195196958e+00 -4.647382922381489e+00 -4.650842231139545e+00 -4.654306122594169e+00 -4.657774598295235e+00 + -4.661247666571815e+00 -4.664725335805659e+00 -4.668207607810025e+00 -4.671694483876048e+00 -4.675185969774820e+00 + -4.678682072408495e+00 -4.682182798723523e+00 -4.685688154522786e+00 -4.689198140990583e+00 -4.692712759891060e+00 + -4.696232019926335e+00 -4.699755929666950e+00 -4.703284490219185e+00 -4.706817702626076e+00 -4.710355575141943e+00 + -4.713898116290367e+00 -4.717445328460708e+00 -4.720997213393779e+00 -4.724553776370427e+00 -4.728115023824750e+00 + -4.731680963263822e+00 -4.735251601139764e+00 -4.738826938611875e+00 -4.742406977241646e+00 -4.745991725492132e+00 + -4.749581191958943e+00 -4.753175378866366e+00 -4.756774287871428e+00 -4.760377924733439e+00 -4.763986296289299e+00 + -4.767599409584012e+00 -4.771217270615820e+00 -4.774839880987831e+00 -4.778467242836293e+00 -4.782099364825118e+00 + -4.785736255481164e+00 -4.789377916255392e+00 -4.793024348603915e+00 -4.796675561079348e+00 -4.800331562360717e+00 + -4.803992354536202e+00 -4.807657939173200e+00 -4.811328322346788e+00 -4.815003511262576e+00 -4.818683513140625e+00 + -4.822368334073276e+00 -4.826057975627521e+00 -4.829752439872078e+00 -4.833451735407881e+00 -4.837155870922971e+00 + -4.840864848921632e+00 -4.844578671297884e+00 -4.848297343688468e+00 -4.852020872870312e+00 -4.855749266438375e+00 + -4.859482530948563e+00 -4.863220667982479e+00 -4.866963679596293e+00 -4.870711574718753e+00 -4.874464362148352e+00 + -4.878222043289993e+00 -4.881984619584831e+00 -4.885752100012597e+00 -4.889524493673498e+00 -4.893301802611106e+00 + -4.897084028340568e+00 -4.900871177319985e+00 -4.904663257144151e+00 -4.908460275011687e+00 -4.912262236942902e+00 + -4.916069144641015e+00 -4.919881000415621e+00 -4.923697813318887e+00 -4.927519592402767e+00 -4.931346339975771e+00 + -4.935178057730553e+00 -4.939014751639765e+00 -4.942856428895341e+00 -4.946703097286389e+00 -4.950554763469543e+00 + -4.954411428974413e+00 -4.958273095882141e+00 -4.962139773607051e+00 -4.966011471374763e+00 -4.969888190322918e+00 + -4.973769931656962e+00 -4.977656704941523e+00 -4.981548519919207e+00 -4.985445378685372e+00 -4.989347282670139e+00 + -4.993254238289898e+00 -4.997166253181426e+00 -5.001083334876794e+00 -5.005005489750602e+00 -5.008932719652265e+00 + -5.012865027026571e+00 -5.016802421224969e+00 -5.020744911403345e+00 -5.024692499028711e+00 -5.028645185619313e+00 + -5.032602980587180e+00 -5.036565893470627e+00 -5.040533926419334e+00 -5.044507081015939e+00 -5.048485363963517e+00 + -5.052468783200935e+00 -5.056457346489804e+00 -5.060451060330298e+00 -5.064449926354071e+00 -5.068453946757710e+00 + -5.072463130865962e+00 -5.076477488052552e+00 -5.080497020758939e+00 -5.084521730904982e+00 -5.088551625256381e+00 + -5.092586711696772e+00 -5.096626997735727e+00 -5.100672489712744e+00 -5.104723189661156e+00 -5.108779100266077e+00 + -5.112840231125939e+00 -5.116906591587866e+00 -5.120978183080382e+00 -5.125055007124604e+00 -5.129137073530554e+00 + -5.133224392250169e+00 -5.137316965514153e+00 -5.141414794882011e+00 -5.145517886949661e+00 -5.149626249667421e+00 + -5.153739891366810e+00 -5.157858819095347e+00 -5.161983034383363e+00 -5.166112539324860e+00 -5.170247343785729e+00 + -5.174387457616170e+00 -5.178532882831751e+00 -5.182683620936045e+00 -5.186839679219287e+00 -5.191001066208124e+00 + -5.195167789588259e+00 -5.199339855740569e+00 -5.203517266667578e+00 -5.207700025095241e+00 -5.211888141021600e+00 + -5.216081624199723e+00 -5.220280476130696e+00 -5.224484698310884e+00 -5.228694300469721e+00 -5.232909292611727e+00 + -5.237129677608738e+00 -5.241355457600706e+00 -5.245586638932716e+00 -5.249823229255573e+00 -5.254065237237846e+00 + -5.258312670369801e+00 -5.262565530410686e+00 -5.266823819583928e+00 -5.271087547700648e+00 -5.275356724632263e+00 + -5.279631352903723e+00 -5.283911434448228e+00 -5.288196976178466e+00 -5.292487986327965e+00 -5.296784473434150e+00 + -5.301086444698075e+00 -5.305393901671405e+00 -5.309706846569482e+00 -5.314025289911748e+00 -5.318349242027271e+00 + -5.322678704179561e+00 -5.327013677718438e+00 -5.331354173404511e+00 -5.335700202105029e+00 -5.340051765703035e+00 + -5.344408865432155e+00 -5.348771508912536e+00 -5.353139705124518e+00 -5.357513462102698e+00 -5.361892786505948e+00 + -5.366277680435933e+00 -5.370668146715638e+00 -5.375064195610523e+00 -5.379465837274747e+00 -5.383873073974794e+00 + -5.388285907439377e+00 -5.392704345133761e+00 -5.397128395890300e+00 -5.401558068273167e+00 -5.405993369375257e+00 + -5.410434300672517e+00 -5.414880864443758e+00 -5.419333071796174e+00 -5.423790933634701e+00 -5.428254451226888e+00 + -5.432723625834648e+00 -5.437198468334746e+00 -5.441678989715544e+00 -5.446165191796978e+00 -5.450657075821366e+00 + -5.455154649888983e+00 -5.459657923508107e+00 -5.464166904961132e+00 -5.468681600997277e+00 -5.473202013458992e+00 + -5.477728145011161e+00 -5.482260006515158e+00 -5.486797608759512e+00 -5.491340954044872e+00 -5.495890044003880e+00 + -5.500444886085005e+00 -5.505005489175888e+00 -5.509571862105057e+00 -5.514144012303452e+00 -5.518721941670775e+00 + -5.523305652810777e+00 -5.527895156674663e+00 -5.532490463993778e+00 -5.537091576272570e+00 -5.541698495053784e+00 + -5.546311231260242e+00 -5.550929796018560e+00 -5.555554191890502e+00 -5.560184420697174e+00 -5.564820489861896e+00 + -5.569462408240030e+00 -5.574110184812914e+00 -5.578763827204064e+00 -5.583423337479740e+00 -5.588088718319627e+00 + -5.592759980414353e+00 -5.597437134453794e+00 -5.602120183113874e+00 -5.606809128447821e+00 -5.611503978032022e+00 + -5.616204740842362e+00 -5.620911425929568e+00 -5.625624040919794e+00 -5.630342587666039e+00 -5.635067068763208e+00 + -5.639797495546991e+00 -5.644533879170592e+00 -5.649276221316504e+00 -5.654024523642824e+00 -5.658778797180806e+00 + -5.663539053129186e+00 -5.668305293983524e+00 -5.673077521581335e+00 -5.677855743831122e+00 -5.682639970117403e+00 + -5.687430209657800e+00 -5.692226470164904e+00 -5.697028753498052e+00 -5.701837062188433e+00 -5.706651407307890e+00 + -5.711471800003379e+00 -5.716298243181697e+00 -5.721130739014699e+00 -5.725969294974640e+00 -5.730813920019088e+00 + -5.735664623746429e+00 -5.740521414337008e+00 -5.745384293658165e+00 -5.750253264219532e+00 -5.755128337412918e+00 + -5.760009524502356e+00 -5.764896827358567e+00 -5.769790247833362e+00 -5.774689797096235e+00 -5.779595486532854e+00 + -5.784507319075965e+00 -5.789425296924678e+00 -5.794349427796488e+00 -5.799279720850703e+00 -5.804216185495535e+00 + -5.809158829710795e+00 -5.814107655513784e+00 -5.819062665706917e+00 -5.824023872195552e+00 -5.828991286593848e+00 + -5.833964910248241e+00 -5.838944744496904e+00 -5.843930800912663e+00 -5.848923091405570e+00 -5.853921618999967e+00 + -5.858926385866531e+00 -5.863937399646989e+00 -5.868954669511408e+00 -5.873978205272220e+00 -5.879008015280387e+00 + -5.884044101398642e+00 -5.889086466127434e+00 -5.894135121006329e+00 -5.899190077679159e+00 -5.904251339167730e+00 + -5.909318907675908e+00 -5.914392790757818e+00 -5.919472997569684e+00 -5.924559538325873e+00 -5.929652421747786e+00 + -5.934751649526802e+00 -5.939857223994977e+00 -5.944969157077114e+00 -5.950087460588470e+00 -5.955212136313389e+00 + -5.960343186070434e+00 -5.965480621845905e+00 -5.970624455737114e+00 -5.975774690117698e+00 -5.980931326619691e+00 + -5.986094373632355e+00 -5.991263841186835e+00 -5.996439739124646e+00 -6.001622075628632e+00 -6.006810852436582e+00 + -6.012006072105073e+00 -6.017207746910874e+00 -6.022415889122929e+00 -6.027630501258702e+00 -6.032851585034692e+00 + -6.038079148714933e+00 -6.043313202169935e+00 -6.048553755148549e+00 -6.053800815867540e+00 -6.059054386536941e+00 + -6.064314470164098e+00 -6.069581078952353e+00 -6.074854224823474e+00 -6.080133909377011e+00 -6.085420134277816e+00 + -6.090712911774160e+00 -6.096012254273324e+00 -6.101318164235261e+00 -6.106630643404864e+00 -6.111949700614082e+00 + -6.117275346267099e+00 -6.122607589969956e+00 -6.127946439669295e+00 -6.133291897472249e+00 -6.138643966380033e+00 + -6.144002658809652e+00 -6.149367987035877e+00 -6.154739953348771e+00 -6.160118559324411e+00 -6.165503813667637e+00 + -6.170895726810269e+00 -6.176294308963303e+00 -6.181699568610070e+00 -6.187111507544039e+00 -6.192530128394146e+00 + -6.197955443821025e+00 -6.203387466288188e+00 -6.208826197438971e+00 -6.214271638855750e+00 -6.219723802697215e+00 + -6.225182701452046e+00 -6.230648338352550e+00 -6.236120715733020e+00 -6.241599841591995e+00 -6.247085725644578e+00 + -6.252578378807894e+00 -6.258077810320607e+00 -6.263584021505486e+00 -6.269097014385768e+00 -6.274616801702433e+00 + -6.280143396389799e+00 -6.285676801437800e+00 -6.291217018848358e+00 -6.296764056615736e+00 -6.302317924554712e+00 + -6.307878633769864e+00 -6.313446193664602e+00 -6.319020605547922e+00 -6.324601871487839e+00 -6.330190004682891e+00 + -6.335785018206249e+00 -6.341386913499118e+00 -6.346995691980793e+00 -6.352611366614864e+00 -6.358233950592316e+00 + -6.363863446469443e+00 -6.369499855900457e+00 -6.375143187565898e+00 -6.380793451939097e+00 -6.386450659638202e+00 + -6.392114819555641e+00 -6.397785933536126e+00 -6.403464004233896e+00 -6.409149044588990e+00 -6.414841067513965e+00 + -6.420540075525660e+00 -6.426246070301758e+00 -6.431959060559017e+00 -6.437679056917068e+00 -6.443406070567963e+00 + -6.449140110779302e+00 -6.454881178548420e+00 -6.460629275812415e+00 -6.466384416537711e+00 -6.472146614484319e+00 + -6.477915870557313e+00 -6.483692185657911e+00 -6.489475573526882e+00 -6.495266048141532e+00 -6.501063611585819e+00 + -6.506868264986595e+00 -6.512680017535606e+00 -6.518498880384615e+00 -6.524324864460620e+00 -6.530157978732819e+00 + -6.535998224564008e+00 -6.541845604255500e+00 -6.547700131469085e+00 -6.553561819849423e+00 -6.559430671612207e+00 + -6.565306688088189e+00 -6.571189878497283e+00 -6.577080253965905e+00 -6.582977825357318e+00 -6.588882601649868e+00 + -6.594794584545345e+00 -6.600713776640095e+00 -6.606640191385222e+00 -6.612573842086468e+00 -6.618514730613387e+00 + -6.624462858757332e+00 -6.630418239433046e+00 -6.636380885778538e+00 -6.642350800701542e+00 -6.648327986279747e+00 + -6.654312451500913e+00 -6.660304207148021e+00 -6.666303264274883e+00 -6.672309632144893e+00 -6.678323312588955e+00 + -6.684344308236361e+00 -6.690372632342481e+00 -6.696408298209058e+00 -6.702451308697293e+00 -6.708501665794167e+00 + -6.714559378430309e+00 -6.720624457416141e+00 -6.726696914137652e+00 -6.732776758078630e+00 -6.738863990538500e+00 + -6.744958613795213e+00 -6.751060642225177e+00 -6.757170089911689e+00 -6.763286957667176e+00 -6.769411246357500e+00 + -6.775542970333119e+00 -6.781682144164359e+00 -6.787828769816468e+00 -6.793982848306231e+00 -6.800144389461610e+00 + -6.806313405086916e+00 -6.812489906080716e+00 -6.818673901333698e+00 -6.824865392610781e+00 -6.831064382650163e+00 + -6.837270885208925e+00 -6.843484914029985e+00 -6.849706471780753e+00 -6.855935560196301e+00 -6.862172188357874e+00 + -6.868416367348060e+00 -6.874668108908677e+00 -6.880927422841348e+00 -6.887194310527692e+00 -6.893468774218006e+00 + -6.899750828057308e+00 -6.906040486046904e+00 -6.912337749718504e+00 -6.918642620544160e+00 -6.924955112226868e+00 + -6.931275238742860e+00 -6.937603002930438e+00 -6.943938406703657e+00 -6.950281459417487e+00 -6.956632172330878e+00 + -6.962990556877839e+00 -6.969356622516854e+00 -6.975730370629293e+00 -6.982111803620415e+00 -6.988500936068168e+00 + -6.994897782349220e+00 -7.001302343862422e+00 -7.007714621896787e+00 -7.014134630279748e+00 -7.020562383120512e+00 + -7.026997883116998e+00 -7.033441132058707e+00 -7.039892139512705e+00 -7.046350916975187e+00 -7.052817475881351e+00 + -7.059291825658977e+00 -7.065773967767182e+00 -7.072263904706783e+00 -7.078761651114045e+00 -7.085267221537997e+00 + -7.091780618043302e+00 -7.098301841735545e+00 -7.104830902368316e+00 -7.111367811800725e+00 -7.117912581665987e+00 + -7.124465221496127e+00 -7.131025732644298e+00 -7.137594117517873e+00 -7.144170390919956e+00 -7.150754567380619e+00 + -7.157346647942116e+00 -7.163946633668109e+00 -7.170554539195697e+00 -7.177170379365883e+00 -7.183794156261903e+00 + -7.190425870988396e+00 -7.197065533493338e+00 -7.203713155838439e+00 -7.210368749697043e+00 -7.217032324589560e+00 + -7.223703881813015e+00 -7.230383423705708e+00 -7.237070964994412e+00 -7.243766520390449e+00 -7.250470092154861e+00 + -7.257181681552523e+00 -7.263901298313877e+00 -7.270628954301988e+00 -7.277364661444877e+00 -7.284108429522252e+00 + -7.290860259655573e+00 -7.297620154032538e+00 -7.304388127764033e+00 -7.311164195737019e+00 -7.317948359019635e+00 + -7.324740618617562e+00 -7.331540989105481e+00 -7.338349485298712e+00 -7.345166109406192e+00 -7.351990862719772e+00 + -7.358823755469352e+00 -7.365664799915581e+00 -7.372514007504119e+00 -7.379371387574386e+00 -7.386236941855793e+00 + -7.393110673113762e+00 -7.399992595867711e+00 -7.406882724521767e+00 -7.413781061264927e+00 -7.420687607444220e+00 + -7.427602373253923e+00 -7.434525370953283e+00 -7.441456612214240e+00 -7.448396106579596e+00 -7.455343855662903e+00 + -7.462299862106879e+00 -7.469264140600134e+00 -7.476236705537742e+00 -7.483217558094771e+00 -7.490206699573982e+00 + -7.497204145008848e+00 -7.504209909607961e+00 -7.511223995549668e+00 -7.518246403916826e+00 -7.525277144440522e+00 + -7.532316229110418e+00 -7.539363670302306e+00 -7.546419478207750e+00 -7.553483653895294e+00 -7.560556199398457e+00 + -7.567637129733686e+00 -7.574726459966183e+00 -7.581824192373288e+00 -7.588930328179804e+00 -7.596044877188221e+00 + -7.603167851392376e+00 -7.610299262973792e+00 -7.617439121971403e+00 -7.624587429666054e+00 -7.631744188388593e+00 + -7.638909413427992e+00 -7.646083119762239e+00 -7.653265308167305e+00 -7.660455979470388e+00 -7.667655148905554e+00 + -7.674862831955687e+00 -7.682079030692125e+00 -7.689303746121935e+00 -7.696536988406601e+00 -7.703778769965018e+00 + -7.711029103091334e+00 -7.718287997777487e+00 -7.725555454931286e+00 -7.732831476489904e+00 -7.740116077592081e+00 + -7.747409273463959e+00 -7.754711066479733e+00 -7.762021457991705e+00 -7.769340458116517e+00 -7.776668079072852e+00 + -7.784004332723263e+00 -7.791349228774319e+00 -7.798702768664788e+00 -7.806064954991001e+00 -7.813435803247359e+00 + -7.820815328504128e+00 -7.828203531237023e+00 -7.835600412067597e+00 -7.843005986795347e+00 -7.850420271453628e+00 + -7.857843267833355e+00 -7.865274976500961e+00 -7.872715407367362e+00 -7.880164572827870e+00 -7.887622485870939e+00 + -7.895089157097287e+00 -7.902564586963549e+00 -7.910048776908389e+00 -7.917541742442640e+00 -7.925043499243823e+00 + -7.932554049584044e+00 -7.940073394568305e+00 -7.947601544038569e+00 -7.955138510136092e+00 -7.962684305462377e+00 + -7.970238940357911e+00 -7.977802415658878e+00 -7.985374733292938e+00 -7.992955909057959e+00 -8.000545958501995e+00 + -8.008144882303682e+00 -8.015752681155906e+00 -8.023369370677967e+00 -8.030994966700497e+00 -8.038629470973136e+00 + -8.046272884117311e+00 -8.053925216322545e+00 -8.061586480220186e+00 -8.069256688640843e+00 -8.076935852017314e+00 + -8.084623970991846e+00 -8.092321047230506e+00 -8.100027096285098e+00 -8.107742133772728e+00 -8.115466161685978e+00 + -8.123199180963685e+00 -8.130941201954130e+00 -8.138692237272345e+00 -8.146452299190864e+00 -8.154221397655556e+00 + -8.161999533648068e+00 -8.169786709369063e+00 -8.177582940859525e+00 -8.185388243772254e+00 -8.193202618367051e+00 + -8.201026064968486e+00 -8.208858599553158e+00 -8.216700238370747e+00 -8.224550983111227e+00 -8.232410834288519e+00 + -8.240279802271914e+00 -8.248157899820946e+00 -8.256045139400785e+00 -8.263941531127587e+00 -8.271847076015916e+00 + -8.279761776165609e+00 -8.287685647119202e+00 -8.295618704371698e+00 -8.303560949785306e+00 -8.311512384182917e+00 + -8.319473017862927e+00 -8.327442863513763e+00 -8.335421933908444e+00 -8.343410239406900e+00 -8.351407780632112e+00 + -8.359414559352070e+00 -8.367430591651793e+00 -8.375455893292965e+00 -8.383490464426892e+00 -8.391534305333888e+00 + -8.399587432420665e+00 -8.407649862295598e+00 -8.415721596247392e+00 -8.423802634359653e+00 -8.431892987215194e+00 + -8.439992667917126e+00 -8.448101689150496e+00 -8.456220061058572e+00 -8.464347784035521e+00 -8.472484859778373e+00 + -8.480631304944675e+00 -8.488787135775029e+00 -8.496952351881781e+00 -8.505126952972617e+00 -8.513310955764712e+00 + -8.521504377280520e+00 -8.529707218754108e+00 -8.537919480083488e+00 -8.546141171610756e+00 -8.554372306334406e+00 + -8.562612897434500e+00 -8.570862955488629e+00 -8.579122480482935e+00 -8.587391473585072e+00 -8.595669951280222e+00 + -8.603957930092136e+00 -8.612255411381385e+00 -8.620562395277888e+00 -8.628878892152137e+00 -8.637204914976417e+00 + -8.645540476889700e+00 -8.653885588365707e+00 -8.662240249050400e+00 -8.670604460002718e+00 -8.678978238761259e+00 + -8.687361602440037e+00 -8.695754549975142e+00 -8.704157080317993e+00 -8.712569210659231e+00 -8.720990958572770e+00 + -8.729422324926496e+00 -8.737863309144757e+00 -8.746313921583734e+00 -8.754774175423437e+00 -8.763244084207386e+00 + -8.771723658743657e+00 -8.780212898534927e+00 -8.788711804325507e+00 -8.797220393131562e+00 -8.805738681960509e+00 + -8.814266671512945e+00 -8.822804361262596e+00 -8.831351762082482e+00 -8.839908887544672e+00 -8.848475750618142e+00 + -8.857052361519681e+00 -8.865638720060298e+00 -8.874234827408518e+00 -8.882840700568694e+00 -8.891456356239988e+00 + -8.900081794065120e+00 -8.908717013654563e+00 -8.917362031546196e+00 -8.926016864607513e+00 -8.934681514097109e+00 + -8.943355979966887e+00 -8.952040272550780e+00 -8.960734404827180e+00 -8.969438389970174e+00 -8.978152238557112e+00 + -8.986875950582608e+00 -8.995609527224275e+00 -9.004352984974421e+00 -9.013106340348738e+00 -9.021869594641789e+00 + -9.030642747850949e+00 -9.039425810005964e+00 -9.048218793898496e+00 -9.057021713335553e+00 -9.065834579375275e+00 + -9.074657391064932e+00 -9.083490148798390e+00 -9.092332870366718e+00 -9.101185573233034e+00 -9.110048256151465e+00 + -9.118920917820537e+00 -9.127803575425368e+00 -9.136696246597257e+00 -9.145598932265708e+00 -9.154511631860180e+00 + -9.163434355511646e+00 -9.172367116215408e+00 -9.181309927722621e+00 -9.190262801063124e+00 -9.199225735625708e+00 + -9.208198731948572e+00 -9.217181806808554e+00 -9.226174977077383e+00 -9.235178243767663e+00 -9.244191606592038e+00 + -9.253215075922315e+00 -9.262248664894432e+00 -9.271292387041701e+00 -9.280346253080740e+00 -9.289410262064051e+00 + -9.298484414471314e+00 -9.307568728155069e+00 -9.316663220573421e+00 -9.325767890233902e+00 -9.334882735648362e+00 + -9.344007774296474e+00 -9.353143024056331e+00 -9.362288485431986e+00 -9.371444157433135e+00 -9.380610050466057e+00 + -9.389786177888119e+00 -9.398972553464475e+00 -9.408169188076664e+00 -9.417376080663951e+00 -9.426593231436920e+00 + -9.435820657633688e+00 -9.445058376575700e+00 -9.454306388890288e+00 -9.463564693828612e+00 -9.472833301831271e+00 + -9.482112226230582e+00 -9.491401480736307e+00 -9.500701076124317e+00 -9.510011011057383e+00 -9.519331285649606e+00 + -9.528661917933491e+00 -9.538002925632075e+00 -9.547354307312132e+00 -9.556716061430350e+00 -9.566088205159264e+00 + -9.575470756067922e+00 -9.584863714595665e+00 -9.594267079809105e+00 -9.603680862413734e+00 -9.613105076017005e+00 + -9.622539734195460e+00 -9.631984847535897e+00 -9.641440414697058e+00 -9.650906435763309e+00 -9.660382928449559e+00 + -9.669869910482992e+00 -9.679367382009378e+00 -9.688875341677877e+00 -9.698393799732578e+00 -9.707922769547205e+00 + -9.717462265419133e+00 -9.727012298576232e+00 -9.736572867044643e+00 -9.746143970285512e+00 -9.755725626701739e+00 + -9.765317854403191e+00 -9.774920651385886e+00 -9.784534015610914e+00 -9.794157965013451e+00 -9.803792517858509e+00 + -9.813437673756464e+00 -9.823093430886084e+00 -9.832759800354408e+00 -9.842436796281985e+00 -9.852124431915341e+00 + -9.861822717446652e+00 -9.871531651724764e+00 -9.881251235098006e+00 -9.890981485255914e+00 -9.900722419735771e+00 + -9.910474038124631e+00 -9.920236338721825e+00 -9.930009332625946e+00 -9.939793033953066e+00 -9.949587456089942e+00 + -9.959392609292857e+00 -9.969208492025555e+00 -9.979035104343238e+00 -9.988872464459540e+00 -9.998720590171930e+00 + -1.000857947945488e+01 -1.001844913033355e+01 -1.002832956085879e+01 -1.003822078906736e+01 -1.004812281291406e+01 + -1.005803562971182e+01 -1.006795925428782e+01 -1.007789370360111e+01 -1.008783898562387e+01 -1.009779510571246e+01 + -1.010776206774677e+01 -1.011773987740720e+01 -1.012772854905251e+01 -1.013772809631413e+01 -1.014773852123577e+01 + -1.015775982444731e+01 -1.016779201251112e+01 -1.017783509576905e+01 -1.018788909374848e+01 -1.019795402262726e+01 + -1.020802987599985e+01 -1.021811664796306e+01 -1.022821435720666e+01 -1.023832302389762e+01 -1.024844264951883e+01 + -1.025857323411911e+01 -1.026871479069502e+01 -1.027886733277511e+01 -1.028903086306819e+01 -1.029920538356622e+01 + -1.030939090421369e+01 -1.031958743714735e+01 -1.032979499532081e+01 -1.034001358910991e+01 -1.035024321776280e+01 + -1.036048388191000e+01 -1.037073559883907e+01 -1.038099838556339e+01 -1.039127224134250e+01 -1.040155716512729e+01 + -1.041185317238784e+01 -1.042216027887615e+01 -1.043247848495290e+01 -1.044280779013644e+01 -1.045314820596725e+01 + -1.046349974688984e+01 -1.047386242694284e+01 -1.048423625623699e+01 -1.049462122957744e+01 -1.050501734396915e+01 + -1.051542462052187e+01 -1.052584308069211e+01 -1.053627272321853e+01 -1.054671354447971e+01 -1.055716555413174e+01 + -1.056762876571201e+01 -1.057810319500591e+01 -1.058858885406686e+01 -1.059908573777257e+01 -1.060959384260205e+01 + -1.062011318861535e+01 -1.063064379594653e+01 -1.064118566144451e+01 -1.065173878128750e+01 -1.066230317225584e+01 + -1.067287885251234e+01 -1.068346582514766e+01 -1.069406409086973e+01 -1.070467365592747e+01 -1.071529452946521e+01 + -1.072592672666786e+01 -1.073657026057826e+01 -1.074722512963040e+01 -1.075789133336255e+01 -1.076856889033910e+01 + -1.077925781838790e+01 -1.078995811336476e+01 -1.080066977044343e+01 -1.081139280404170e+01 -1.082212723175914e+01 + -1.083287306467895e+01 -1.084363031023443e+01 -1.085439896777578e+01 -1.086517903841335e+01 -1.087597053838113e+01 + -1.088677348334085e+01 -1.089758787154147e+01 -1.090841370173705e+01 -1.091925099211483e+01 -1.093009976068779e+01 + -1.094096000533889e+01 -1.095183172286895e+01 -1.096271492588021e+01 -1.097360962990334e+01 -1.098451584638146e+01 + -1.099543358339704e+01 -1.100636283967740e+01 -1.101730361593110e+01 -1.102825593014644e+01 -1.103921979985815e+01 + -1.105019522350652e+01 -1.106118219809120e+01 -1.107218073394329e+01 -1.108319084475604e+01 -1.109421254433972e+01 + -1.110524584310812e+01 -1.111629073777213e+01 -1.112734722664297e+01 -1.113841532813614e+01 -1.114949506055284e+01 + -1.116058642163307e+01 -1.117168940919924e+01 -1.118280404196459e+01 -1.119393033845125e+01 -1.120506829552628e+01 + -1.121621790821428e+01 -1.122737918582522e+01 -1.123855214233318e+01 -1.124973679608346e+01 -1.126093316109601e+01 + -1.127214122971816e+01 -1.128336099568353e+01 -1.129459247994368e+01 -1.130583570391351e+01 -1.131709066364352e+01 + -1.132835735316995e+01 -1.133963578383626e+01 -1.135092597165251e+01 -1.136222793398803e+01 -1.137354168289046e+01 + -1.138486720776133e+01 -1.139620450077960e+01 -1.140755358788016e+01 -1.141891449467379e+01 -1.143028721171902e+01 + -1.144167172931863e+01 -1.145306807180483e+01 -1.146447626363145e+01 -1.147589629570943e+01 -1.148732815744427e+01 + -1.149877186576219e+01 -1.151022744176966e+01 -1.152169489577362e+01 -1.153317423307527e+01 -1.154466544975234e+01 + -1.155616854500299e+01 -1.156768353973055e+01 -1.157921045411968e+01 -1.159074928377541e+01 -1.160230002278200e+01 + -1.161386268372032e+01 -1.162543728297182e+01 -1.163702383362365e+01 -1.164862234413445e+01 -1.166023280774309e+01 + -1.167185522083641e+01 -1.168348960761297e+01 -1.169513599109641e+01 -1.170679436179895e+01 -1.171846471050954e+01 + -1.173014706163534e+01 -1.174184143967664e+01 -1.175354783588804e+01 -1.176526623959987e+01 -1.177699666569085e+01 + -1.178873913359907e+01 -1.180049365545172e+01 -1.181226023874721e+01 -1.182403887977966e+01 -1.183582957710202e+01 + -1.184763234950681e+01 -1.185944721571250e+01 -1.187127417390187e+01 -1.188311322026980e+01 -1.189496436359524e+01 + -1.190682761635663e+01 -1.191870299324639e+01 -1.193059050542573e+01 -1.194249014771712e+01 -1.195440191732676e+01 + -1.196632583733436e+01 -1.197826192918009e+01 -1.199021018187259e+01 -1.200217058481946e+01 -1.201414316145583e+01 + -1.202612793653577e+01 -1.203812490606177e+01 -1.205013406283600e+01 -1.206215541561094e+01 -1.207418897775090e+01 + -1.208623476511758e+01 -1.209829279023755e+01 -1.211036304979982e+01 -1.212244554104682e+01 -1.213454027927224e+01 + -1.214664728029985e+01 -1.215876654402256e+01 -1.217089806888390e+01 -1.218304186346073e+01 -1.219519793969503e+01 + -1.220736631285608e+01 -1.221954699446002e+01 -1.223173997768314e+01 -1.224394525782826e+01 -1.225616285704409e+01 + -1.226839279716718e+01 -1.228063507193962e+01 -1.229288967419984e+01 -1.230515662126608e+01 -1.231743593190913e+01 + -1.232972760623024e+01 -1.234203164189830e+01 -1.235434804552219e+01 -1.236667682754052e+01 -1.237901800477097e+01 + -1.239137159078778e+01 -1.240373757981251e+01 -1.241611596680448e+01 -1.242850676902663e+01 -1.244091000477032e+01 + -1.245332567413717e+01 -1.246575377485128e+01 -1.247819431331654e+01 -1.249064729993889e+01 -1.250311275245252e+01 + -1.251559068470151e+01 -1.252808108764087e+01 -1.254058395403090e+01 -1.255309930674196e+01 -1.256562716858205e+01 + -1.257816753199971e+01 -1.259072038911156e+01 -1.260328576106586e+01 -1.261586366917709e+01 -1.262845410639316e+01 + -1.264105706405277e+01 -1.265367255542431e+01 -1.266630059802175e+01 -1.267894120441173e+01 -1.269159438291520e+01 + -1.270426012981745e+01 -1.271693844300063e+01 -1.272962933876972e+01 -1.274233283335257e+01 -1.275504892424538e+01 + -1.276777760888006e+01 -1.278051890316245e+01 -1.279327282335948e+01 -1.280603936870822e+01 -1.281881853703964e+01 + -1.283161033759003e+01 -1.284441478278821e+01 -1.285723188642777e+01 -1.287006165845383e+01 -1.288290409205257e+01 + -1.289575918258311e+01 -1.290862695085492e+01 -1.292150741744502e+01 -1.293440057655018e+01 -1.294730642109768e+01 + -1.296022496531707e+01 -1.297315622664438e+01 -1.298610021403966e+01 -1.299905693252094e+01 -1.301202637981436e+01 + -1.302500855607946e+01 -1.303800347850134e+01 -1.305101116311717e+01 -1.306403160434687e+01 -1.307706479749205e+01 + -1.309011076299821e+01 -1.310316952145874e+01 -1.311624106891474e+01 -1.312932539865738e+01 -1.314242251753035e+01 + -1.315553243732881e+01 -1.316865517610136e+01 -1.318179074759510e+01 -1.319493914209791e+01 -1.320810035188408e+01 + -1.322127440063306e+01 -1.323446131182036e+01 -1.324766107670098e+01 -1.326087368408213e+01 -1.327409914520021e+01 + -1.328733747660298e+01 -1.330058869365459e+01 -1.331385280702646e+01 -1.332712980980294e+01 -1.334041969690924e+01 + -1.335372248822127e+01 -1.336703820316815e+01 -1.338036683444133e+01 -1.339370837465144e+01 -1.340706284282357e+01 + -1.342043025877972e+01 -1.343381061911550e+01 -1.344720391854233e+01 -1.346061016746156e+01 -1.347402937953320e+01 + -1.348746156576247e+01 -1.350090673400032e+01 -1.351436488213541e+01 -1.352783600940468e+01 -1.354132013040003e+01 + -1.355481725974633e+01 -1.356832739684519e+01 -1.358185053959114e+01 -1.359538669507347e+01 -1.360893587411229e+01 + -1.362249809325635e+01 -1.363607336498644e+01 -1.364966167978290e+01 -1.366326303005515e+01 -1.367687743792930e+01 + -1.369050492543861e+01 -1.370414548452841e+01 -1.371779910680898e+01 -1.373146581263829e+01 -1.374514562258463e+01 + -1.375883852931014e+01 -1.377254452369323e+01 -1.378626361738342e+01 -1.379999582664259e+01 -1.381374116541099e+01 + -1.382749964295472e+01 -1.384127125216480e+01 -1.385505598801133e+01 -1.386885387015567e+01 -1.388266491822051e+01 + -1.389648912698253e+01 -1.391032648926665e+01 -1.392417701493663e+01 -1.393804071810552e+01 -1.395191761284479e+01 + -1.396580770902492e+01 -1.397971099975399e+01 -1.399362747983656e+01 -1.400755716762526e+01 -1.402150008127576e+01 + -1.403545621460787e+01 -1.404942556175519e+01 -1.406340814244217e+01 -1.407740397661280e+01 -1.409141305949836e+01 + -1.410543538386059e+01 -1.411947095729565e+01 -1.413351979216372e+01 -1.414758190504674e+01 -1.416165730817942e+01 + -1.417574599218579e+01 -1.418984794931155e+01 -1.420396319989974e+01 -1.421809176459019e+01 -1.423223363711269e+01 + -1.424638880961032e+01 -1.426055729478944e+01 -1.427473910897708e+01 -1.428893426241975e+01 -1.430314276106135e+01 + -1.431736459971596e+01 -1.433159977568000e+01 -1.434584830730895e+01 -1.436011021230267e+01 -1.437438548467938e+01 + -1.438867411856965e+01 -1.440297613223502e+01 -1.441729154417122e+01 -1.443162034967981e+01 -1.444596254173529e+01 + -1.446031812719803e+01 -1.447468711827448e+01 -1.448906953466952e+01 -1.450346539077074e+01 -1.451787467219810e+01 + -1.453229736674074e+01 -1.454673349963205e+01 -1.456118309651608e+01 -1.457564614723534e+01 -1.459012263904241e+01 + -1.460461258463169e+01 -1.461911600163362e+01 -1.463363290198108e+01 -1.464816329304780e+01 -1.466270716966852e+01 + -1.467726452861927e+01 -1.469183538698022e+01 -1.470641976118071e+01 -1.472101764474266e+01 -1.473562903182180e+01 + -1.475025394201659e+01 -1.476489239431922e+01 -1.477954437985420e+01 -1.479420988900897e+01 -1.480888893709030e+01 + -1.482358154289730e+01 -1.483828771427918e+01 -1.485300745484606e+01 -1.486774076220148e+01 -1.488248763590571e+01 + -1.489724808935241e+01 -1.491202213620220e+01 -1.492680977735018e+01 -1.494161101188853e+01 -1.495642584446314e+01 + -1.497125428281713e+01 -1.498609634152866e+01 -1.500095203243959e+01 -1.501582134961145e+01 -1.503070428834008e+01 + -1.504560086663885e+01 -1.506051110171047e+01 -1.507543498479744e+01 -1.509037250787217e+01 -1.510532369178669e+01 + -1.512028855781273e+01 -1.513526710002122e+01 -1.515025931004586e+01 -1.516526519697226e+01 -1.518028477406786e+01 + -1.519531805387558e+01 -1.521036504514735e+01 -1.522542574219565e+01 -1.524050014105165e+01 -1.525558825906066e+01 + -1.527069011317451e+01 -1.528580569745696e+01 -1.530093500454836e+01 -1.531607804428359e+01 -1.533123483115148e+01 + -1.534640538106230e+01 -1.536158970459035e+01 -1.537678778954449e+01 -1.539199962605270e+01 -1.540722523628471e+01 + -1.542246464244602e+01 -1.543771783484346e+01 -1.545298480379291e+01 -1.546826557154514e+01 -1.548356016030771e+01 + -1.549886856018057e+01 -1.551419075889859e+01 -1.552952676684366e+01 -1.554487659991805e+01 -1.556024027345857e+01 + -1.557561779759322e+01 -1.559100916218038e+01 -1.560641435912106e+01 -1.562183340875659e+01 -1.563726633124305e+01 + -1.565271311755539e+01 -1.566817375858786e+01 -1.568364827409284e+01 -1.569913668435983e+01 -1.571463898296877e+01 + -1.573015516140282e+01 -1.574568522946743e+01 -1.576122920078429e+01 -1.577678708591764e+01 -1.579235889192325e+01 + -1.580794461488044e+01 -1.582354425266206e+01 -1.583915782129173e+01 -1.585478533595468e+01 -1.587042679033195e+01 + -1.588608217713541e+01 -1.590175150670428e+01 -1.591743479377280e+01 -1.593313205302798e+01 -1.594884329356461e+01 + -1.596456850215542e+01 -1.598030766876410e+01 -1.599606081844003e+01 -1.601182797567503e+01 -1.602760912764517e+01 + -1.604340426053651e+01 -1.605921339389068e+01 -1.607503654929621e+01 -1.609087372317365e+01 -1.610672490846679e+01 + -1.612259010938000e+01 -1.613846933535691e+01 -1.615436260553746e+01 -1.617026993400350e+01 -1.618619130490810e+01 + -1.620212670496088e+01 -1.621807616102629e+01 -1.623403970021593e+01 -1.625001731047507e+01 -1.626600897617460e+01 + -1.628201470655392e+01 -1.629803451699528e+01 -1.631406842258372e+01 -1.633011643368945e+01 -1.634617854212047e+01 + -1.636225474110459e+01 -1.637834504811086e+01 -1.639444948009596e+01 -1.641056802772599e+01 -1.642670068226715e+01 + -1.644284746367691e+01 -1.645900839255391e+01 -1.647518346337059e+01 -1.649137266740475e+01 -1.650757600928198e+01 + -1.652379349905581e+01 -1.654002515514406e+01 -1.655627099138395e+01 -1.657253099492616e+01 -1.658880515436409e+01 + -1.660509349074862e+01 -1.662139602569388e+01 -1.663771275060954e+01 -1.665404365442992e+01 -1.667038874639235e+01 + -1.668674804082613e+01 -1.670312155212567e+01 -1.671950928959044e+01 -1.673591124207530e+01 -1.675232740091000e+01 + -1.676875778776886e+01 -1.678520242381186e+01 -1.680166129779755e+01 -1.681813439803682e+01 -1.683462174345131e+01 + -1.685112335404732e+01 -1.686763922355921e+01 -1.688416934305047e+01 -1.690071371917313e+01 -1.691727236387981e+01 + -1.693384529473730e+01 -1.695043252373442e+01 -1.696703403493436e+01 -1.698364981519248e+01 -1.700027989045860e+01 + -1.701692428668450e+01 -1.703358299073511e+01 -1.705025598664567e+01 -1.706694328621936e+01 -1.708364490699094e+01 + -1.710036086165371e+01 -1.711709115711999e+01 -1.713383578201967e+01 -1.715059472804424e+01 -1.716736801741393e+01 + -1.718415567151382e+01 -1.720095767785962e+01 -1.721777402421613e+01 -1.723460473321376e+01 -1.725144982735173e+01 + -1.726830929373925e+01 -1.728518311723097e+01 -1.730207130905323e+01 -1.731897388644410e+01 -1.733589086431708e+01 + -1.735282225151622e+01 -1.736976803493245e+01 -1.738672820398455e+01 -1.740370278015603e+01 -1.742069178532102e+01 + -1.743769521085149e+01 -1.745471304524893e+01 -1.747174529603476e+01 -1.748879197614670e+01 -1.750585310116775e+01 + -1.752292868122209e+01 -1.754001870195336e+01 -1.755712315207324e+01 -1.757424205704595e+01 -1.759137544124289e+01 + -1.760852328791187e+01 -1.762568558032359e+01 -1.764286234296404e+01 -1.766005360135051e+01 -1.767725934391039e+01 + -1.769447955614261e+01 -1.771171424892207e+01 -1.772896343807829e+01 -1.774622713388326e+01 -1.776350534196338e+01 + -1.778079805492016e+01 -1.779810526797336e+01 -1.781542699984077e+01 -1.783276326793605e+01 -1.785011406095838e+01 + -1.786747936642481e+01 -1.788485919583838e+01 -1.790225356596892e+01 -1.791966249066770e+01 -1.793708597750879e+01 + -1.795452401187612e+01 -1.797197658287230e+01 -1.798944371666477e+01 -1.800692543788475e+01 -1.802442172795408e+01 + -1.804193256819016e+01 -1.805945798270200e+01 -1.807699799758296e+01 -1.809455260407236e+01 -1.811212178929598e+01 + -1.812970555877947e+01 -1.814730392419934e+01 -1.816491690343573e+01 -1.818254450889657e+01 -1.820018672489731e+01 + -1.821784353770839e+01 -1.823551496951270e+01 -1.825320104351004e+01 -1.827090175105552e+01 -1.828861707995103e+01 + -1.830634703563002e+01 -1.832409162961503e+01 -1.834185088015348e+01 -1.835962479982180e+01 -1.837741337178776e+01 + -1.839521658191638e+01 -1.841303445627024e+01 -1.843086702044687e+01 -1.844871425798603e+01 -1.846657615155986e+01 + -1.848445272242748e+01 -1.850234399331442e+01 -1.852024995422484e+01 -1.853817059263430e+01 -1.855610591862525e+01 + -1.857405594751762e+01 -1.859202069297440e+01 -1.861000016303027e+01 -1.862799434486363e+01 -1.864600322762024e+01 + -1.866402682917165e+01 -1.868206516860479e+01 -1.870011824114266e+01 -1.871818603889838e+01 -1.873626856540951e+01 + -1.875436582948875e+01 -1.877247784962497e+01 -1.879060463922456e+01 -1.880874618168810e+01 -1.882690246254704e+01 + -1.884507350586227e+01 -1.886325933574866e+01 -1.888145993800745e+01 -1.889967529731236e+01 -1.891790543214035e+01 + -1.893615036295555e+01 -1.895441008436764e+01 -1.897268458788422e+01 -1.899097387845919e+01 -1.900927796546465e+01 + -1.902759686249918e+01 -1.904593057916082e+01 -1.906427910481893e+01 -1.908264243109121e+01 -1.910102057881749e+01 + -1.911941356739387e+01 -1.913782138121961e+01 -1.915624400568942e+01 -1.917468146517671e+01 -1.919313378404767e+01 + -1.921160094766128e+01 -1.923008293912871e+01 -1.924857977157690e+01 -1.926709146357444e+01 -1.928561802544077e+01 + -1.930415946120927e+01 -1.932271575801813e+01 -1.934128690695999e+01 -1.935987293184044e+01 -1.937847385553680e+01 + -1.939708966450047e+01 -1.941572034241033e+01 -1.943436589828115e+01 -1.945302634705033e+01 -1.947170170200994e+01 + -1.949039197138318e+01 -1.950909714476303e+01 -1.952781721398065e+01 -1.954655219845012e+01 -1.956530211609402e+01 + -1.958406695128608e+01 -1.960284668959667e+01 -1.962164135493148e+01 -1.964045097168231e+01 -1.965927552785040e+01 + -1.967811500826448e+01 -1.969696942145404e+01 -1.971583878200212e+01 -1.973472310500559e+01 -1.975362239928199e+01 + -1.977253664801789e+01 -1.979146583743514e+01 -1.981040999152762e+01 -1.982936913462439e+01 -1.984834325462312e+01 + -1.986733233626431e+01 -1.988633638809098e+01 -1.990535542475069e+01 -1.992438946150660e+01 -1.994343850724086e+01 + -1.996250254469571e+01 -1.998158155988759e+01 -2.000067557806942e+01 -2.001978462401460e+01 -2.003890868134189e+01 + -2.005804773353269e+01 -2.007720180467363e+01 -2.009637091866160e+01 -2.011555505802958e+01 -2.013475420367532e+01 + -2.015396837131929e+01 -2.017319758216888e+01 -2.019244184455664e+01 -2.021170116029698e+01 -2.023097551800653e+01 + -2.025026491057744e+01 -2.026956936120177e+01 -2.028888889127859e+01 -2.030822348473533e+01 -2.032757312336421e+01 + -2.034693781788847e+01 -2.036631758558183e+01 -2.038571244098909e+01 -2.040512239225047e+01 -2.042454742461679e+01 + -2.044398752597867e+01 -2.046344271767523e+01 -2.048291302072143e+01 -2.050239842138679e+01 -2.052189890581644e+01 + -2.054141449440303e+01 -2.056094520839277e+01 -2.058049103819856e+01 -2.060005197091200e+01 -2.061962801117254e+01 + -2.063921916971323e+01 -2.065882546409381e+01 -2.067844690614864e+01 -2.069808347798381e+01 -2.071773516441981e+01 + -2.073740199086278e+01 -2.075708398272239e+01 -2.077678112483692e+01 -2.079649339928443e+01 -2.081622081767353e+01 + -2.083596339752241e+01 -2.085572115045732e+01 -2.087549408142252e+01 -2.089528217452614e+01 -2.091508541798258e+01 + -2.093490383726751e+01 -2.095473745703866e+01 -2.097458626142068e+01 -2.099445023367205e+01 -2.101432939411960e+01 + -2.103422376365449e+01 -2.105413332835716e+01 -2.107405807288499e+01 -2.109399801101360e+01 -2.111395316146354e+01 + -2.113392353361706e+01 -2.115390913036233e+01 -2.117390993794961e+01 -2.119392594678185e+01 -2.121395718051052e+01 + -2.123400366165125e+01 -2.125406537492771e+01 -2.127414230292253e+01 -2.129423445744600e+01 -2.131434185603574e+01 + -2.133446450991120e+01 -2.135460242400538e+01 -2.137475558442359e+01 -2.139492398094176e+01 -2.141510763684612e+01 + -2.143530657354728e+01 -2.145552077144329e+01 -2.147575021223202e+01 -2.149599492382317e+01 -2.151625493458459e+01 + -2.153653022850520e+01 -2.155682078515937e+01 -2.157712661084235e+01 -2.159744772002078e+01 -2.161778413312624e+01 + -2.163813586321833e+01 -2.165850288790379e+01 -2.167888518769065e+01 -2.169928279014487e+01 -2.171969572392566e+01 + -2.174012397500749e+01 -2.176056752455845e+01 -2.178102637720577e+01 -2.180150054539059e+01 -2.182199004935065e+01 + -2.184249490264348e+01 -2.186301508430896e+01 -2.188355057625899e+01 -2.190410140641098e+01 -2.192466760199104e+01 + -2.194524914145450e+01 -2.196584600311797e+01 -2.198645821351363e+01 -2.200708580045210e+01 -2.202772874864248e+01 + -2.204838703903658e+01 -2.206906068065864e+01 -2.208974968965916e+01 -2.211045408262128e+01 -2.213117386881762e+01 + -2.215190902784613e+01 -2.217265954271720e+01 -2.219342543976576e+01 -2.221420674565993e+01 -2.223500344507609e+01 + -2.225581551916326e+01 -2.227664297695268e+01 -2.229748583458740e+01 -2.231834410877561e+01 -2.233921780886325e+01 + -2.236010691418214e+01 -2.238101140757746e+01 -2.240193131596196e+01 -2.242286666626994e+01 -2.244381744145418e+01 + -2.246478362333585e+01 -2.248576523319086e+01 -2.250676229308250e+01 -2.252777478876882e+01 -2.254880270395783e+01 + -2.256984605046237e+01 -2.259090484578745e+01 -2.261197910210208e+01 -2.263306882483333e+01 -2.265417399777652e+01 + -2.267529460825966e+01 -2.269643067937303e+01 -2.271758223358744e+01 -2.273874925513337e+01 -2.275993172840441e+01 + -2.278112967668665e+01 -2.280234312326570e+01 -2.282357205253301e+01 -2.284481644618636e+01 -2.286607631404299e+01 + -2.288735167241803e+01 -2.290864253549898e+01 -2.292994891082159e+01 -2.295127078144212e+01 -2.297260813386354e+01 + -2.299396099285480e+01 -2.301532938287575e+01 -2.303671328888409e+01 -2.305811269234469e+01 -2.307952760025338e+01 + -2.310095802706863e+01 -2.312240399156859e+01 -2.314386550544134e+01 -2.316534254769484e+01 -2.318683510020089e+01 + -2.320834318896662e+01 -2.322986684000025e+01 -2.325140603517923e+01 -2.327296075598023e+01 -2.329453102640753e+01 + -2.331611687084991e+01 -2.333771827270656e+01 -2.335933521295700e+01 -2.338096770389138e+01 -2.340261576396985e+01 + -2.342427940502197e+01 -2.344595863230511e+01 -2.346765343141823e+01 -2.348936379112492e+01 -2.351108973250527e+01 + -2.353283127622654e+01 -2.355458840898814e+01 -2.357636111469370e+01 -2.359814940003157e+01 -2.361995327887107e+01 + -2.364177277102066e+01 -2.366360788867084e+01 -2.368545860760097e+01 -2.370732490730504e+01 -2.372920681854641e+01 + -2.375110437181196e+01 -2.377301754521346e+01 -2.379494631547129e+01 -2.381689070611525e+01 -2.383885074279985e+01 + -2.386082641286912e+01 -2.388281770027697e+01 -2.390482461372720e+01 -2.392684716763744e+01 -2.394888537453080e+01 + -2.397093924094647e+01 -2.399300875138237e+01 -2.401509389381072e+01 -2.403719469214220e+01 -2.405931116939521e+01 + -2.408144330908079e+01 -2.410359109227195e+01 -2.412575452979684e+01 -2.414793363861520e+01 -2.417012843045825e+01 + -2.419233891107258e+01 -2.421456506749473e+01 -2.423680688969797e+01 -2.425906439811232e+01 -2.428133761196757e+01 + -2.430362651523593e+01 -2.432593109247103e+01 -2.434825136580965e+01 -2.437058735754595e+01 -2.439293905302052e+01 + -2.441530643508021e+01 -2.443768951355032e+01 -2.446008830475372e+01 -2.448250282402539e+01 -2.450493307947941e+01 + -2.452737905133441e+01 -2.454984072340254e+01 -2.457231812176549e+01 -2.459481127247106e+01 -2.461732015916192e+01 + -2.463984476198997e+01 -2.466238508954903e+01 -2.468494115731883e+01 -2.470751297988127e+01 -2.473010056541401e+01 + -2.475270389737600e+01 -2.477532296279144e+01 -2.479795778766421e+01 -2.482060839605179e+01 -2.484327476524651e+01 + -2.486595687297807e+01 -2.488865474549064e+01 -2.491136841050829e+01 -2.493409785316058e+01 -2.495684305468689e+01 + -2.497960402336061e+01 -2.500238077436705e+01 -2.502517332350563e+01 -2.504798167938967e+01 -2.507080582127416e+01 + -2.509364573240812e+01 -2.511650144137505e+01 -2.513937297643642e+01 -2.516226031923135e+01 -2.518516344740990e+01 + -2.520808236928804e+01 -2.523101710100030e+01 -2.525396765928963e+01 -2.527693405405919e+01 -2.529991626724470e+01 + -2.532291428361040e+01 -2.534592812720204e+01 -2.536895782110043e+01 -2.539200334524508e+01 -2.541506468057373e+01 + -2.543814185515816e+01 -2.546123489657537e+01 -2.548434378328921e+01 -2.550746849096137e+01 -2.553060903315797e+01 + -2.555376543163097e+01 -2.557693770297151e+01 -2.560012585444837e+01 -2.562332986120158e+01 -2.564654970308929e+01 + -2.566978541097076e+01 -2.569303701597250e+01 -2.571630449928904e+01 -2.573958783754457e+01 -2.576288703901380e+01 + -2.578620212017663e+01 -2.580953309868325e+01 -2.583287998467666e+01 -2.585624275710073e+01 -2.587962139846310e+01 + -2.590301593672573e+01 -2.592642639921134e+01 -2.594985276523152e+01 -2.597329501305775e+01 -2.599675316481207e+01 + -2.602022724494944e+01 -2.604371724340627e+01 -2.606722314554395e+01 -2.609074495294231e+01 -2.611428267453130e+01 + -2.613783633242288e+01 -2.616140594232113e+01 -2.618499148111656e+01 -2.620859292804694e+01 -2.623221031055255e+01 + -2.625584365675950e+01 -2.627949294933480e+01 -2.630315816707157e+01 -2.632683931872623e+01 -2.635053642045652e+01 + -2.637424948806206e+01 -2.639797853015353e+01 -2.642172352694394e+01 -2.644548446269175e+01 -2.646926136623515e+01 + -2.649305426487780e+01 -2.651686313520573e+01 -2.654068795336410e+01 -2.656452874445229e+01 -2.658838553565089e+01 + -2.661225831351167e+01 -2.663614706041860e+01 -2.666005178271351e+01 -2.668397249386109e+01 -2.670790921185966e+01 + -2.673186194785124e+01 -2.675583068101895e+01 -2.677981539336416e+01 -2.680381611012034e+01 -2.682783285712106e+01 + -2.685186561936856e+01 -2.687591437786270e+01 -2.689997913842517e+01 -2.692405991477839e+01 -2.694815672742597e+01 + -2.697226958936361e+01 -2.699639847677425e+01 -2.702054336911223e+01 -2.704470429573021e+01 -2.706888128546201e+01 + -2.709307431516761e+01 -2.711728336172764e+01 -2.714150845407871e+01 -2.716574962162754e+01 -2.719000684360529e+01 + -2.721428009605862e+01 -2.723856939247152e+01 -2.726287475352885e+01 -2.728719619128178e+01 -2.731153370993099e+01 + -2.733588729090867e+01 -2.736025692081293e+01 -2.738464262967399e+01 -2.740904444482641e+01 -2.743346233939021e+01 + -2.745789628706843e+01 -2.748234631811058e+01 -2.750681246441337e+01 -2.753129470791622e+01 -2.755579302585287e+01 + -2.758030742659158e+01 -2.760483792680023e+01 -2.762938454521084e+01 -2.765394729250735e+01 -2.767852614511706e+01 + -2.770312108289846e+01 -2.772773213369129e+01 -2.775235932608502e+01 -2.777700264368704e+01 -2.780166206614083e+01 + -2.782633760221619e+01 -2.785102926812099e+01 -2.787573708068912e+01 -2.790046104903706e+01 -2.792520115078565e+01 + -2.794995736764946e+01 -2.797472972921345e+01 -2.799951826412358e+01 -2.802432294939970e+01 -2.804914376169005e+01 + -2.807398072778233e+01 -2.809883387567351e+01 -2.812370318805837e+01 -2.814858864438241e+01 -2.817349025639583e+01 + -2.819840804241009e+01 -2.822334201467696e+01 -2.824829217820057e+01 -2.827325851505399e+01 -2.829824101147483e+01 + -2.832323969328987e+01 -2.834825458594292e+01 -2.837328567375688e+01 -2.839833293713809e+01 -2.842339638194745e+01 + -2.844847602232610e+01 -2.847357188008160e+01 -2.849868396869187e+01 -2.852381226064981e+01 -2.854895673259501e+01 + -2.857411741873861e+01 -2.859929435285462e+01 -2.862448750939692e+01 -2.864969686163745e+01 -2.867492243744038e+01 + -2.870016426611871e+01 -2.872542232818885e+01 -2.875069660076976e+01 -2.877598709618692e+01 -2.880129383482867e+01 + -2.882661683412842e+01 -2.885195610246809e+01 -2.887731161497835e+01 -2.890268335136361e+01 -2.892807134287440e+01 + -2.895347562064698e+01 -2.897889616381469e+01 -2.900433294736006e+01 -2.902978598166526e+01 -2.905525528595928e+01 + -2.908074087945912e+01 -2.910624277257485e+01 -2.913176094050105e+01 -2.915729536236611e+01 -2.918284606824940e+01 + -2.920841308797334e+01 -2.923399639938179e+01 -2.925959597987842e+01 -2.928521185708459e+01 -2.931084405942344e+01 + -2.933649256830759e+01 -2.936215736109871e+01 -2.938783844596477e+01 -2.941353583979598e+01 -2.943924956356517e+01 + -2.946497963001566e+01 -2.949072601489006e+01 -2.951648869675137e+01 -2.954226770244480e+01 -2.956806305999476e+01 + -2.959387475386040e+01 -2.961970276467950e+01 -2.964554710136948e+01 -2.967140778023144e+01 -2.969728481882160e+01 + -2.972317822671904e+01 -2.974908798033929e+01 -2.977501406036931e+01 -2.980095649774566e+01 -2.982691532231985e+01 + -2.985289050935425e+01 -2.987888203414534e+01 -2.990488992671488e+01 -2.993091421806754e+01 -2.995695488841446e+01 + -2.998301191396682e+01 -3.000908530572931e+01 -3.003517508294127e+01 -3.006128126298706e+01 -3.008740385472813e+01 + -3.011354283478899e+01 -3.013969818396866e+01 -3.016586993200092e+01 -3.019205810852835e+01 -3.021826269389396e+01 + -3.024448366459688e+01 -3.027072103106001e+01 -3.029697481234801e+01 -3.032324502816885e+01 -3.034953168930138e+01 + -3.037583477016444e+01 -3.040215424919064e+01 -3.042849015722735e+01 -3.045484252487287e+01 -3.048121132931426e+01 + -3.050759654718701e+01 -3.053399820633122e+01 -3.056041633582694e+01 -3.058685091850949e+01 -3.061330193277164e+01 + -3.063976938548045e+01 -3.066625329189824e+01 -3.069275367239408e+01 -3.071927054017274e+01 -3.074580387467516e+01 + -3.077235365736276e+01 -3.079891991154272e+01 -3.082550266154129e+01 -3.085210189391538e+01 -3.087871759159065e+01 + -3.090534976073683e+01 -3.093199841535169e+01 -3.095866357750086e+01 -3.098534526117247e+01 -3.101204343997652e+01 + -3.103875809113482e+01 -3.106548924669440e+01 -3.109223693806243e+01 -3.111900113926174e+01 -3.114578182447812e+01 + -3.117257902593346e+01 -3.119939277712214e+01 -3.122622305859262e+01 -3.125306984560579e+01 -3.127993314521812e+01 + -3.130681297362548e+01 -3.133370935178603e+01 -3.136062229292185e+01 -3.138755177454848e+01 -3.141449777743489e+01 + -3.144146033107010e+01 -3.146843946420585e+01 -3.149543515392452e+01 -3.152244737446985e+01 -3.154947614039987e+01 + -3.157652147508332e+01 -3.160358339681746e+01 -3.163066191390917e+01 -3.165775699977537e+01 -3.168486863280270e+01 + -3.171199684614663e+01 -3.173914167265754e+01 -3.176630308919665e+01 -3.179348107134120e+01 -3.182067564552154e+01 + -3.184788683989369e+01 -3.187511463866380e+01 -3.190235902163426e+01 -3.192961999494226e+01 -3.195689757352222e+01 + -3.198419178116283e+01 -3.201150263346307e+01 -3.203883010440887e+01 -3.206617417058478e+01 -3.209353486058297e+01 + -3.212091220418486e+01 -3.214830618392138e+01 -3.217571677868305e+01 -3.220314400004898e+01 -3.223058786708538e+01 + -3.225804839611857e+01 -3.228552559489243e+01 -3.231301943956095e+01 -3.234052991162765e+01 -3.236805704558397e+01 + -3.239560087404328e+01 -3.242316136911894e+01 -3.245073850255218e+01 -3.247833230509534e+01 -3.250594280965240e+01 + -3.253356999872297e+01 -3.256121385028732e+01 -3.258887437465276e+01 -3.261655158960600e+01 -3.264424551052439e+01 + -3.267195614529539e+01 -3.269968347425627e+01 -3.272742748229857e+01 -3.275518820008119e+01 -3.278296565603427e+01 + -3.281075982390590e+01 -3.283857067801981e+01 -3.286639824968410e+01 -3.289424257141810e+01 -3.292210362360176e+01 + -3.294998138240963e+01 -3.297787585933321e+01 -3.300578707421773e+01 -3.303371504500630e+01 -3.306165978102434e+01 + -3.308962125902853e+01 -3.311759946003357e+01 -3.314559441465483e+01 -3.317360615365304e+01 -3.320163465877013e+01 + -3.322967990687330e+01 -3.325774190434956e+01 -3.328582066713852e+01 -3.331391621987054e+01 -3.334202857831301e+01 + -3.337015771409062e+01 -3.339830360273710e+01 -3.342646627956469e+01 -3.345464577921614e+01 -3.348284207387808e+01 + -3.351105513572078e+01 -3.353928499930519e+01 -3.356753169996216e+01 -3.359579521371194e+01 -3.362407551222610e+01 + -3.365237260909204e+01 -3.368068652715969e+01 -3.370901728441355e+01 -3.373736488954338e+01 -3.376572931892538e+01 + -3.379411055342771e+01 -3.382250862419983e+01 -3.385092356238306e+01 -3.387935534880526e+01 -3.390780395979943e+01 + -3.393626940403256e+01 -3.396475169950308e+01 -3.399325086920118e+01 -3.402176692682492e+01 -3.405029984391190e+01 + -3.407884959628061e+01 -3.410741621903333e+01 -3.413599974690003e+01 -3.416460015383780e+01 -3.419321741347679e+01 + -3.422185155891206e+01 -3.425050262370409e+01 -3.427917058381036e+01 -3.430785541111823e+01 -3.433655711883738e+01 + -3.436527572977491e+01 -3.439401126380553e+01 -3.442276373145798e+01 -3.445153310880944e+01 -3.448031937598221e+01 + -3.450912256373026e+01 -3.453794270224409e+01 -3.456677976882821e+01 -3.459563373771100e+01 -3.462450462370172e+01 + -3.465339245071625e+01 -3.468229723851619e+01 -3.471121899611902e+01 -3.474015769371995e+01 -3.476911330776019e+01 + -3.479808587848705e+01 -3.482707544447295e+01 -3.485608197378501e+01 -3.488510543365825e+01 -3.491414585850467e+01 + -3.494320328527482e+01 -3.497227769389696e+01 -3.500136905869145e+01 -3.503047738856913e+01 -3.505960270226024e+01 + -3.508874502318216e+01 -3.511790436512474e+01 -3.514708069868058e+01 -3.517627399907308e+01 -3.520548430324607e+01 + -3.523471164812467e+01 -3.526395600883895e+01 -3.529321735592740e+01 -3.532249570335686e+01 -3.535179107461137e+01 + -3.538110348781549e+01 -3.541043295179184e+01 -3.543977944351469e+01 -3.546914294470585e+01 -3.549852348792567e+01 + -3.552792110371767e+01 -3.555733576371960e+01 -3.558676744035331e+01 -3.561621616808287e+01 -3.564568198278825e+01 + -3.567516486397158e+01 -3.570466478590109e+01 -3.573418175828719e+01 -3.576371580017962e+01 -3.579326693254331e+01 + -3.582283516733191e+01 -3.585242047853867e+01 -3.588202284498269e+01 -3.591164230274704e+01 -3.594127888660625e+01 + -3.597093256883734e+01 -3.600060331833949e+01 -3.603029115299790e+01 -3.605999610029281e+01 -3.608971817709886e+01 + -3.611945738978410e+01 -3.614921371329605e+01 -3.617898712799953e+01 -3.620877766734910e+01 -3.623858536391516e+01 + -3.626841019364145e+01 -3.629825213180558e+01 -3.632811120764664e+01 -3.635798745148868e+01 -3.638788084403422e+01 + -3.641779136227628e+01 -3.644771901799147e+01 -3.647766383142195e+01 -3.650762582188893e+01 -3.653760499949427e+01 + -3.656760133838370e+01 -3.659761481766282e+01 -3.662764547223315e+01 -3.665769333671685e+01 -3.668775838882340e+01 + -3.671784060113342e+01 -3.674793998262476e+01 -3.677805655273779e+01 -3.680819033636626e+01 -3.683834134900049e+01 + -3.686850956306390e+01 -3.689869495454472e+01 -3.692889755675729e+01 -3.695911740229619e+01 -3.698935446355054e+01 + -3.701960871343802e+01 -3.704988018719579e+01 -3.708016892120266e+01 -3.711047489408478e+01 -3.714079807933708e+01 + -3.717113848768184e+01 -3.720149613882988e+01 -3.723187105121882e+01 -3.726226323497034e+01 -3.729267266821555e+01 + -3.732309933333587e+01 -3.735354326170426e+01 -3.738400448395760e+01 -3.741448297879693e+01 -3.744497872108128e+01 + -3.747549172223736e+01 -3.750602200310610e+01 -3.753656958561755e+01 -3.756713448177913e+01 -3.759771666281819e+01 + -3.762831610507856e+01 -3.765893284615005e+01 -3.768956692232328e+01 -3.772021830344675e+01 -3.775088695941269e+01 + -3.778157292673024e+01 -3.781227624306894e+01 -3.784299688412320e+01 -3.787373482086582e+01 -3.790449006735824e+01 + -3.793526264738479e+01 -3.796605258053289e+01 -3.799685987630166e+01 -3.802768450803411e+01 -3.805852645435349e+01 + -3.808938575116029e+01 -3.812026243387959e+01 -3.815115647875793e+01 -3.818206785737669e+01 -3.821299658183555e+01 + -3.824394267407146e+01 -3.827490615485264e+01 -3.830588703573063e+01 -3.833688529255877e+01 -3.836790090523419e+01 + -3.839893390552727e+01 -3.842998432385276e+01 -3.846105213333004e+01 -3.849213730842061e+01 -3.852323988624988e+01 + -3.855435990371658e+01 -3.858549733414936e+01 -3.861665214665468e+01 -3.864782435702053e+01 -3.867901399128823e+01 + -3.871022106983104e+01 -3.874144560188923e+01 -3.877268755783931e+01 -3.880394691415978e+01 -3.883522371060106e+01 + -3.886651798555487e+01 -3.889782970870629e+01 -3.892915884903668e+01 -3.896050544141922e+01 -3.899186952243698e+01 + -3.902325106962145e+01 -3.905465005558139e+01 -3.908606649228560e+01 -3.911750040150871e+01 -3.914895180488885e+01 + -3.918042071436301e+01 -3.921190710320024e+01 -3.924341094905042e+01 -3.927493228575462e+01 -3.930647114756201e+01 + -3.933802751416320e+01 -3.936960136044893e+01 -3.940119269666864e+01 -3.943280154239230e+01 -3.946442791911308e+01 + -3.949607183932866e+01 -3.952773327763106e+01 -3.955941221301939e+01 -3.959110868002649e+01 -3.962282271157864e+01 + -3.965455427864192e+01 -3.968630335291520e+01 -3.971806997098832e+01 -3.974985417066340e+01 -3.978165592970123e+01 + -3.981347522024374e+01 -3.984531205199855e+01 -3.987716644515135e+01 -3.990903842423468e+01 -3.994092800366619e+01 + -3.997283515305731e+01 -4.000475984705376e+01 -4.003670212524431e+01 -4.006866202678586e+01 -4.010063952416471e+01 + -4.013263458527370e+01 -4.016464722630246e+01 -4.019667747391531e+01 -4.022872534837892e+01 -4.026079085897078e+01 + -4.029287397740929e+01 -4.032497468131004e+01 -4.035709300943645e+01 -4.038922899883853e+01 -4.042138261856475e+01 + -4.045355383733334e+01 -4.048574269054266e+01 -4.051794921541258e+01 -4.055017338976896e+01 -4.058241518694505e+01 + -4.061467462169752e+01 -4.064695171778673e+01 -4.067924649356458e+01 -4.071155895737036e+01 -4.074388908290122e+01 + -4.077623684962312e+01 -4.080860229471885e+01 -4.084098545450960e+01 -4.087338630415373e+01 -4.090580481395003e+01 + -4.093824099592192e+01 -4.097069487270115e+01 -4.100316646762842e+01 -4.103565579436854e+01 -4.106816282717386e+01 + -4.110068754422534e+01 -4.113322997883087e+01 -4.116579016300655e+01 -4.119836806847471e+01 -4.123096366815907e+01 + -4.126357700008218e+01 -4.129620810254014e+01 -4.132885694982463e+01 -4.136152351139461e+01 -4.139420780138244e+01 + -4.142690984447184e+01 -4.145962966287846e+01 -4.149236726828771e+01 -4.152512263273182e+01 -4.155789573295193e+01 + -4.159068660417814e+01 -4.162349528189675e+01 -4.165632174413023e+01 -4.168916596438000e+01 -4.172202795552684e+01 + -4.175490773972726e+01 -4.178780533686147e+01 -4.182072075745918e+01 -4.185365397692470e+01 -4.188660497553830e+01 + -4.191957378820953e+01 -4.195256044830271e+01 -4.198556492837179e+01 -4.201858720098863e+01 -4.205162729960676e+01 + -4.208468525919077e+01 -4.211776105986812e+01 -4.215085467691669e+01 -4.218396612105321e+01 -4.221709541226407e+01 + -4.225024257217616e+01 -4.228340761361360e+01 -4.231659051254899e+01 -4.234979124870078e+01 -4.238300985362200e+01 + -4.241624635885866e+01 -4.244950074409413e+01 -4.248277298525672e+01 -4.251606309511715e+01 -4.254937109530931e+01 + -4.258269700607782e+01 -4.261604083828603e+01 -4.264940256666174e+01 -4.268278217100897e+01 -4.271617968757233e+01 + -4.274959515039267e+01 -4.278302852825576e+01 -4.281647979114838e+01 -4.284994897911630e+01 -4.288343613339240e+01 + -4.291694122989936e+01 -4.295046423857267e+01 -4.298400517070971e+01 -4.301756404788966e+01 -4.305114089145757e+01 + -4.308473571388112e+01 -4.311834849235274e+01 -4.315197920801049e+01 -4.318562789305037e+01 -4.321929457904871e+01 + -4.325297924404543e+01 -4.328668186207582e+01 -4.332040244469275e+01 -4.335414101381126e+01 -4.338789759527743e+01 + -4.342167220389723e+01 -4.345546480638487e+01 -4.348927537558045e+01 -4.352310395691921e+01 -4.355695059370569e+01 + -4.359081524812669e+01 -4.362469788222823e+01 -4.365859853861065e+01 -4.369251726260594e+01 -4.372645402991838e+01 + -4.376040880917880e+01 -4.379438161035186e+01 -4.382837245512241e+01 -4.386238137072252e+01 -4.389640837367813e+01 + -4.393045343214298e+01 -4.396451651875527e+01 -4.399859767246311e+01 -4.403269693263155e+01 -4.406681427398399e+01 + -4.410094966630350e+01 -4.413510312425358e+01 -4.416927467295284e+01 -4.420346433446015e+01 -4.423767212069691e+01 + -4.427189800609401e+01 -4.430614196966567e+01 -4.434040404624994e+01 -4.437468426893484e+01 -4.440898260798443e+01 + -4.444329903479183e+01 -4.447763358808973e+01 -4.451198630763288e+01 -4.454635716992501e+01 -4.458074614621454e+01 + -4.461515324997958e+01 -4.464957850449220e+01 -4.468402192997090e+01 -4.471848353715485e+01 -4.475296330191956e+01 + -4.478746120505344e+01 -4.482197728186011e+01 -4.485651156648301e+01 -4.489106403390974e+01 -4.492563465506775e+01 + -4.496022344379944e+01 -4.499483042484561e+01 -4.502945562362576e+01 -4.506409905435962e+01 -4.509876068578905e+01 + -4.513344049220396e+01 -4.516813851556444e+01 -4.520285479589762e+01 -4.523758929782897e+01 -4.527234198687941e+01 + -4.530711290755342e+01 -4.534190210524451e+01 -4.537670954991925e+01 -4.541153520580425e+01 -4.544637908959269e+01 + -4.548124122972980e+01 -4.551612164920255e+01 -4.555102035951307e+01 -4.558593733168242e+01 -4.562087254236648e+01 + -4.565582603124118e+01 -4.569079783605451e+01 -4.572578792382265e+01 -4.576079626235065e+01 -4.579582289333027e+01 + -4.583086785976433e+01 -4.586593113601344e+01 -4.590101269036680e+01 -4.593611253546989e+01 -4.597123069530716e+01 + -4.600636719486254e+01 -4.604152204856955e+01 -4.607669522766013e+01 -4.611188670797630e+01 -4.614709652700154e+01 + -4.618232472227299e+01 -4.621757126990104e+01 -4.625283614113306e+01 -4.628811934919114e+01 -4.632342091751210e+01 + -4.635874086841728e+01 -4.639407921460932e+01 -4.642943593143147e+01 -4.646481099859044e+01 -4.650020445060623e+01 + -4.653561632090474e+01 -4.657104658372261e+01 -4.660649521327068e+01 -4.664196224284595e+01 -4.667744770698098e+01 + -4.671295158606459e+01 -4.674847385553061e+01 -4.678401452513644e+01 -4.681957361522331e+01 -4.685515115414413e+01 + -4.689074715945064e+01 -4.692636159747788e+01 -4.696199443933372e+01 -4.699764572643400e+01 -4.703331550121288e+01 + -4.706900373987032e+01 -4.710471041222129e+01 -4.714043552877479e+01 -4.717617911151273e+01 -4.721194118761495e+01 + -4.724772177397794e+01 -4.728352084116666e+01 -4.731933836391387e+01 -4.735517437995513e+01 -4.739102892624472e+01 + -4.742690197360956e+01 -4.746279349304486e+01 -4.749870352234630e+01 -4.753463210070628e+01 -4.757057920610364e+01 + -4.760654481072343e+01 -4.764252892478859e+01 -4.767853156968457e+01 -4.771455277340900e+01 -4.775059255327958e+01 + -4.778665087728216e+01 -4.782272771801416e+01 -4.785882311585065e+01 -4.789493711157514e+01 -4.793106967982698e+01 + -4.796722079021173e+01 -4.800339045834357e+01 -4.803957871014897e+01 -4.807578556679541e+01 -4.811201103905631e+01 + -4.814825510088780e+01 -4.818451773166895e+01 -4.822079896928767e+01 -4.825709884980719e+01 -4.829341734348342e+01 + -4.832975442115909e+01 -4.836611012183125e+01 -4.840248448526336e+01 -4.843887748613056e+01 -4.847528909416636e+01 + -4.851171932442625e+01 -4.854816820273300e+01 -4.858463575265701e+01 -4.862112198691646e+01 -4.865762687707282e+01 + -4.869415040003414e+01 -4.873069259525141e+01 -4.876725350118260e+01 -4.880383308977095e+01 -4.884043132904604e+01 + -4.887704823789731e+01 -4.891368384608068e+01 -4.895033817595851e+01 -4.898701123776245e+01 -4.902370300059485e+01 + -4.906041344002308e+01 -4.909714259860375e+01 -4.913389051725400e+01 -4.917065716334413e+01 -4.920744250429804e+01 + -4.924424658130064e+01 -4.928106943700116e+01 -4.931791104614518e+01 -4.935477137752828e+01 -4.939165044404930e+01 + -4.942854827009338e+01 -4.946546488188807e+01 -4.950240029454247e+01 -4.953935447684974e+01 -4.957632740294361e+01 + -4.961331911463601e+01 -4.965032965315336e+01 -4.968735898970213e+01 -4.972440709120082e+01 -4.976147397743583e+01 + -4.979855967878247e+01 -4.983566421510402e+01 -4.987278759472007e+01 -4.990992979028766e+01 -4.994709078100569e+01 + -4.998427060790318e+01 -5.002146930959274e+01 -5.005868685319148e+01 -5.009592320640078e+01 -5.013317841075434e+01 + -5.017045250915469e+01 -5.020774547614742e+01 -5.024505728017924e+01 -5.028238793365752e+01 -5.031973746104961e+01 + -5.035710589110189e+01 -5.039449324090066e+01 -5.043189947661289e+01 -5.046932456973549e+01 -5.050676856400442e+01 + -5.054423150327239e+01 -5.058171335962052e+01 -5.061921409929316e+01 -5.065673373695915e+01 -5.069427229950105e+01 + -5.073182981423184e+01 -5.076940629607507e+01 -5.080700170996615e+01 -5.084461602753602e+01 -5.088224929718589e+01 + -5.091990156525010e+01 -5.095757279302548e+01 -5.099526294209112e+01 -5.103297206019221e+01 -5.107070019605169e+01 + -5.110844731613729e+01 -5.114621338143406e+01 -5.118399841325091e+01 -5.122180244526444e+01 -5.125962550029841e+01 + -5.129746758802490e+01 -5.133532867636215e+01 -5.137320874011100e+01 -5.141110782335645e+01 -5.144902596945006e+01 + -5.148696314952589e+01 -5.152491932947918e+01 -5.156289452646703e+01 -5.160088876945014e+01 -5.163890208334180e+01 + -5.167693448081514e+01 -5.171498592963017e+01 -5.175305640369855e+01 -5.179114594645165e+01 -5.182925460014935e+01 + -5.186738233284598e+01 -5.190552911234031e+01 -5.194369497961412e+01 -5.198187997663295e+01 -5.202008407611459e+01 + -5.205830724580739e+01 -5.209654950282933e+01 -5.213481087573764e+01 -5.217309138947744e+01 -5.221139105690054e+01 + -5.224970984609732e+01 -5.228804773087789e+01 -5.232640475269200e+01 -5.236478095346914e+01 -5.240317630941821e+01 + -5.244159079031952e+01 -5.248002440595931e+01 -5.251847717885386e+01 -5.255694914243367e+01 -5.259544031823210e+01 + -5.263395066927961e+01 -5.267248016335085e+01 -5.271102884570031e+01 -5.274959676081755e+01 -5.278818387265291e+01 + -5.282679014593192e+01 -5.286541562901994e+01 -5.290406037048660e+01 -5.294272433607927e+01 -5.298140748616263e+01 + -5.302010984239256e+01 -5.305883143892672e+01 -5.309757229863885e+01 -5.313633243133304e+01 -5.317511180581835e+01 + -5.321391039785607e+01 -5.325272825201081e+01 -5.329156541074357e+01 -5.333042183929739e+01 -5.336929750308754e+01 + -5.340819244543594e+01 -5.344710671111962e+01 -5.348604027282968e+01 -5.352499309722418e+01 -5.356396519891433e+01 + -5.360295660504364e+01 -5.364196734493171e+01 -5.368099743556814e+01 -5.372004684244607e+01 -5.375911553606044e+01 + -5.379820355840945e+01 -5.383731095277006e+01 -5.387643769603123e+01 -5.391558375867469e+01 -5.395474915194053e+01 + -5.399393389872404e+01 -5.403313802778240e+01 -5.407236155707715e+01 -5.411160445552515e+01 -5.415086669663323e+01 + -5.419014832131279e+01 -5.422944936941720e+01 -5.426876980916325e+01 -5.430810960961936e+01 -5.434746881489674e+01 + -5.438684746929877e+01 -5.442624554285502e+01 -5.446566300018413e+01 -5.450509985853421e+01 -5.454455614758906e+01 + -5.458403189414573e+01 -5.462352711279953e+01 -5.466304177222543e+01 -5.470257584656953e+01 -5.474212937778257e+01 + -5.478170240720980e+01 -5.482129490597043e+01 -5.486090684084346e+01 -5.490053823147309e+01 -5.494018910890276e+01 + -5.497985949690793e+01 -5.501954940653937e+01 -5.505925880521750e+01 -5.509898766755921e+01 -5.513873604059781e+01 + -5.517850396943321e+01 -5.521829141901578e+01 -5.525809835354192e+01 -5.529792481434151e+01 -5.533777084523449e+01 + -5.537763642286803e+01 -5.541752151714192e+01 -5.545742613813913e+01 -5.549735030880384e+01 -5.553729406334213e+01 + -5.557725742375872e+01 -5.561724035199087e+01 -5.565724281465346e+01 -5.569726485713910e+01 -5.573730652628086e+01 + -5.577736779589668e+01 -5.581744863307357e+01 -5.585754905099014e+01 -5.589766907536871e+01 -5.593780873601526e+01 + -5.597796805069111e+01 -5.601814698489535e+01 -5.605834550959182e+01 -5.609856366986563e+01 -5.613880151023810e+01 + -5.617905899885479e+01 -5.621933610311022e+01 -5.625963286377015e+01 -5.629994932270948e+01 -5.634028545286861e+01 + -5.638064122221132e+01 -5.642101664772899e+01 -5.646141175844968e+01 -5.650182658252075e+01 -5.654226113528433e+01 + -5.658271538174220e+01 -5.662318929319503e+01 -5.666368291647893e+01 -5.670419629786259e+01 -5.674472940580990e+01 + -5.678528220346420e+01 -5.682585471049146e+01 -5.686644695909487e+01 -5.690705897510426e+01 -5.694769077129006e+01 + -5.698834231455854e+01 -5.702901357847642e+01 -5.706970460911611e+01 -5.711041545084194e+01 -5.715114606868026e+01 + -5.719189642778805e+01 -5.723266657318249e+01 -5.727345655110785e+01 -5.731426633285666e+01 -5.735509588339112e+01 + -5.739594521730356e+01 -5.743681436264626e+01 -5.747770335168147e+01 -5.751861220364783e+01 -5.755954088147938e+01 + -5.760048935348805e+01 -5.764145766580183e+01 -5.768244586550730e+01 -5.772345392571002e+01 -5.776448181276131e+01 + -5.780552953997691e+01 -5.784659713354442e+01 -5.788768462417462e+01 -5.792879202998626e+01 -5.796991931420698e+01 + -5.801106644664837e+01 -5.805223347834903e+01 -5.809342045860209e+01 -5.813462734849197e+01 -5.817585410820936e+01 + -5.821710078257841e+01 -5.825836741928538e+01 -5.829965399283203e+01 -5.834096047087346e+01 -5.838228686686274e+01 + -5.842363320676851e+01 -5.846499952082397e+01 -5.850638582715609e+01 -5.854779209120221e+01 -5.858921828442874e+01 + -5.863066445510763e+01 -5.867213065032231e+01 -5.871361683559694e+01 -5.875512297138874e+01 -5.879664907944645e+01 + -5.883819519466417e+01 -5.887976134322624e+01 -5.892134753756825e+01 -5.896295374384051e+01 -5.900457993500612e+01 + -5.904622615756436e+01 -5.908789245663575e+01 -5.912957879828990e+01 -5.917128514850664e+01 -5.921301155195771e+01 + -5.925475805384439e+01 -5.929652462279476e+01 -5.933831122286624e+01 -5.938011787640643e+01 -5.942194461763230e+01 + -5.946379146994821e+01 -5.950565844408734e+01 -5.954754551091072e+01 -5.958945264733813e+01 -5.963137989439624e+01 + -5.967332729249499e+01 -5.971529481547052e+01 -5.975728243227523e+01 -5.979929015889982e+01 -5.984131802305070e+01 + -5.988336605225896e+01 -5.992543426246962e+01 -5.996752262345901e+01 -6.000963111046766e+01 -6.005175976676178e+01 + -6.009390863383608e+01 -6.013607767807394e+01 -6.017826686618813e+01 -6.022047624132026e+01 -6.026270584835797e+01 + -6.030495566274465e+01 -6.034722565381767e+01 -6.038951583593452e+01 -6.043182623512069e+01 -6.047415687905394e+01 + -6.051650778421003e+01 -6.055887892060463e+01 -6.060127026325783e+01 -6.064368185366749e+01 -6.068611373308907e+01 + -6.072856587533070e+01 -6.077103824887340e+01 -6.081353086833690e+01 -6.085604376132918e+01 -6.089857696127247e+01 + -6.094113048823596e+01 -6.098370430306234e+01 -6.102629837247437e+01 -6.106891274594116e+01 -6.111154747264118e+01 + -6.115420251784390e+01 -6.119687784580902e+01 -6.123957350066591e+01 -6.128228952841628e+01 -6.132502590268162e+01 + -6.136778259056138e+01 -6.141055960544676e+01 -6.145335697380811e+01 -6.149617472814099e+01 -6.153901288864162e+01 + -6.158187142028389e+01 -6.162475029314290e+01 -6.166764955292113e+01 -6.171056924466600e+01 -6.175350933517737e+01 + -6.179646979123154e+01 -6.183945065775757e+01 -6.188245198047678e+01 -6.192547373012725e+01 -6.196851587175868e+01 + -6.201157842265037e+01 -6.205466141333163e+01 -6.209776487510229e+01 -6.214088882566958e+01 -6.218403322759970e+01 + -6.222719804958889e+01 -6.227038333999444e+01 -6.231358914752139e+01 -6.235681544260558e+01 -6.240006218936849e+01 + -6.244332940494305e+01 -6.248661712010740e+01 -6.252992536720910e+01 -6.257325416420860e+01 -6.261660346994837e+01 + -6.265997325077347e+01 -6.270336356215701e+01 -6.274677445777788e+01 -6.279020589501037e+01 -6.283365783085999e+01 + -6.287713031716163e+01 -6.292062340781234e+01 -6.296413707012920e+01 -6.300767126475596e+01 -6.305122601222295e+01 + -6.309480134635203e+01 -6.313839729424505e+01 -6.318201386936521e+01 -6.322565103734121e+01 -6.326930877093868e+01 + -6.331298711930568e+01 -6.335668613058504e+01 -6.340040577251647e+01 -6.344414600718050e+01 -6.348790685442323e+01 + -6.353168834759008e+01 -6.357549051625812e+01 -6.361931337593239e+01 -6.366315688959789e+01 -6.370702102749119e+01 + -6.375090584137499e+01 -6.379481138078580e+01 -6.383873760482961e+01 -6.388268447297220e+01 -6.392665203654889e+01 + -6.397064034897519e+01 -6.401464938011861e+01 -6.405867909237229e+01 -6.410272950177993e+01 -6.414680063823367e+01 + -6.419089253336912e+01 -6.423500520539493e+01 -6.427913861706836e+01 -6.432329273774181e+01 -6.436746761859949e+01 + -6.441166331065573e+01 -6.445587978241413e+01 -6.450011699516882e+01 -6.454437496388719e+01 -6.458865371852110e+01 + -6.463295329528786e+01 -6.467727371608086e+01 -6.472161493923234e+01 -6.476597692945877e+01 -6.481035974057480e+01 + -6.485476342551981e+01 -6.489918794463497e+01 -6.494363325783405e+01 -6.498809941591921e+01 -6.503258647107099e+01 + -6.507709439009531e+01 -6.512162313341831e+01 -6.516617272132122e+01 -6.521074318787740e+01 -6.525533456247440e+01 + -6.529994686059398e+01 -6.534458004678092e+01 -6.538923409250538e+01 -6.543390904787570e+01 -6.547860496211884e+01 + -6.552332180229843e+01 -6.556805952953434e+01 -6.561281816333469e+01 -6.565759773746066e+01 -6.570239828429803e+01 + -6.574721982146080e+01 -6.579206230885156e+01 -6.583692571363754e+01 -6.588181008975629e+01 -6.592671548982709e+01 + -6.597164187442638e+01 -6.601658920334479e+01 -6.606155752527242e+01 -6.610654689090467e+01 -6.615155727005924e+01 + -6.619658862652422e+01 -6.624164098084657e+01 -6.628671436645676e+01 -6.633180881156068e+01 -6.637692433038681e+01 + -6.642206088647883e+01 -6.646721845110714e+01 -6.651239707713407e+01 -6.655759681603797e+01 -6.660281763216933e+01 + -6.664805948389387e+01 -6.669332239276561e+01 -6.673860639512726e+01 -6.678391152328841e+01 -6.682923779433044e+01 + -6.687458516845543e+01 -6.691995361277515e+01 -6.696534317891920e+01 -6.701075391795754e+01 -6.705618579420361e+01 + -6.710163877100581e+01 -6.714711289460833e+01 -6.719260821321966e+01 -6.723812470001026e+01 -6.728366232121398e+01 + -6.732922109035582e+01 -6.737480103488133e+01 -6.742040219062761e+01 -6.746602458035952e+01 -6.751166816616187e+01 + -6.755733291529161e+01 -6.760301887637438e+01 -6.764872609859751e+01 -6.769445455202660e+01 -6.774020420051386e+01 + -6.778597506217976e+01 -6.783176716876942e+01 -6.787758055225885e+01 -6.792341523092826e+01 -6.796927116804379e+01 + -6.801514833341810e+01 -6.806104677806347e+01 -6.810696655123587e+01 -6.815290761396663e+01 -6.819886992772128e+01 + -6.824485354392678e+01 -6.829085851532395e+01 -6.833688480994840e+01 -6.838293238885097e+01 -6.842900126984890e+01 + -6.847509148538957e+01 -6.852120306967514e+01 -6.856733604269469e+01 -6.861349036583006e+01 -6.865966600658993e+01 + -6.870586301559659e+01 -6.875208144399036e+01 -6.879832126187024e+01 -6.884458243234171e+01 -6.889086497157696e+01 + -6.893716890990422e+01 -6.898349428120915e+01 -6.902984110598732e+01 -6.907620934761650e+01 -6.912259897511596e+01 + -6.916901003718877e+01 -6.921544258172949e+01 -6.926189657371528e+01 -6.930837197817074e+01 -6.935486884322755e+01 + -6.940138721768092e+01 -6.944792706987337e+01 -6.949448836290087e+01 -6.954107111932564e+01 -6.958767537490402e+01 + -6.963430115870300e+01 -6.968094848498497e+01 -6.972761731548312e+01 -6.977430762020695e+01 -6.982101945480034e+01 + -6.986775287255249e+01 -6.991450783170005e+01 -6.996128429032680e+01 -7.000808230095708e+01 -7.005490191787665e+01 + -7.010174310797666e+01 -7.014860583121035e+01 -7.019549010717337e+01 -7.024239597049470e+01 -7.028932345629492e+01 + -7.033627258446040e+01 -7.038324331344937e+01 -7.043023560838913e+01 -7.047724952251053e+01 -7.052428510987777e+01 + -7.057134233978515e+01 -7.061842117397924e+01 -7.066552162878578e+01 -7.071264373512433e+01 -7.075978752771100e+01 + -7.080695302731498e+01 -7.085414019512091e+01 -7.090134899910394e+01 -7.094857949398551e+01 -7.099583173235354e+01 + -7.104310567151599e+01 -7.109040126922885e+01 -7.113771858031990e+01 -7.118505766125368e+01 -7.123241847797109e+01 + -7.127980098937178e+01 -7.132720521671429e+01 -7.137463119544236e+01 -7.142207895538176e+01 -7.146954851252747e+01 + -7.151703983316882e+01 -7.156455289009196e+01 -7.161208773177542e+01 -7.165964440570248e+01 -7.170722287968356e+01 + -7.175482311646741e+01 -7.180244513822917e+01 -7.185008898098621e+01 -7.189775467669884e+01 -7.194544224180910e+01 + -7.199315163474331e+01 -7.204088282234626e+01 -7.208863586315185e+01 -7.213641081375658e+01 -7.218420763131780e+01 + -7.223202627227879e+01 -7.227986678966526e+01 -7.232772923884254e+01 -7.237561358795277e+01 -7.242351979769759e+01 + -7.247144788623903e+01 -7.251939788668284e+01 -7.256736983444897e+01 -7.261536375015235e+01 -7.266337959287341e+01 + -7.271141732841731e+01 -7.275947701102203e+01 -7.280755869538000e+01 -7.285566234956853e+01 -7.290378793432680e+01 + -7.295193546765573e+01 -7.300010498266862e+01 -7.304829651566631e+01 -7.309651008753943e+01 -7.314474565435016e+01 + -7.319300317971540e+01 -7.324128272229925e+01 -7.328958433981238e+01 -7.333790799110540e+01 -7.338625363374130e+01 + -7.343462131899291e+01 -7.348301110053259e+01 -7.353142294792167e+01 -7.357985682361442e+01 -7.362831274574745e+01 + -7.367679074711965e+01 -7.372529086349638e+01 -7.377381311579366e+01 -7.382235746256312e+01 -7.387092386912651e+01 + -7.391951239025020e+01 -7.396812308115555e+01 -7.401675590943988e+01 -7.406541083531380e+01 -7.411408787706513e+01 + -7.416278706814910e+01 -7.421150844461324e+01 -7.426025202733783e+01 -7.430901777394124e+01 -7.435780564940528e+01 + -7.440661571142732e+01 -7.445544801616209e+01 -7.450430252087864e+01 -7.455317918285648e+01 -7.460207805830268e+01 + -7.465099920497126e+01 -7.469994258787753e+01 -7.474890816454140e+01 -7.479789595523943e+01 -7.484690599592756e+01 + -7.489593832252380e+01 -7.494499295533201e+01 -7.499406985223764e+01 -7.504316897827101e+01 -7.509229038945979e+01 + -7.514143414169166e+01 -7.519060019929748e+01 -7.523978851997632e+01 -7.528899912645726e+01 -7.533823205657275e+01 + -7.538748734353926e+01 -7.543676500532445e+01 -7.548606500351643e+01 -7.553538730703876e+01 -7.558473197053598e+01 + -7.563409904619321e+01 -7.568348849063742e+01 -7.573290026170078e+01 -7.578233441759443e+01 -7.583179101796470e+01 + -7.588127002782028e+01 -7.593077140392674e+01 -7.598029516471465e+01 -7.602984134475692e+01 -7.607940998153097e+01 + -7.612900109746634e+01 -7.617861465189691e+01 -7.622825061065345e+01 -7.627790902865043e+01 -7.632758996032740e+01 + -7.637729336914126e+01 -7.642701921265419e+01 -7.647676751583191e+01 -7.652653831849052e+01 -7.657633165244424e+01 + -7.662614753370475e+01 -7.667598592307560e+01 -7.672584678949215e+01 -7.677573018962489e+01 -7.682563617769370e+01 + -7.687556471038147e+01 -7.692551574474433e+01 -7.697548933686781e+01 -7.702548554509247e+01 -7.707550433774978e+01 + -7.712554567498073e+01 -7.717560957417300e+01 -7.722569606768573e+01 -7.727580519051753e+01 -7.732593696392289e+01 + -7.737609135154067e+01 -7.742626832278943e+01 -7.747646792782194e+01 -7.752669021677298e+01 -7.757693515897095e+01 + -7.762720271798948e+01 -7.767749291518889e+01 -7.772780578562232e+01 -7.777814136132783e+01 -7.782849965970544e+01 + -7.787888064261847e+01 -7.792928427988689e+01 -7.797971062869398e+01 -7.803015974345008e+01 -7.808063158011076e+01 + -7.813112609521906e+01 -7.818164334612277e+01 -7.823218339188995e+01 -7.828274619766600e+01 -7.833333172107952e+01 + -7.838393998361434e+01 -7.843457102192369e+01 -7.848522486948340e+01 -7.853590154498607e+01 -7.858660101116894e+01 + -7.863732323758104e+01 -7.868806827697425e+01 -7.873883618163512e+01 -7.878962691878654e+01 -7.884044044940295e+01 + -7.889127679452803e+01 -7.894213598992800e+01 -7.899301807018992e+01 -7.904392305456564e+01 -7.909485090214494e+01 + -7.914580158005610e+01 -7.919677514774288e+01 -7.924777166238927e+01 -7.929879107982515e+01 -7.934983335558289e+01 + -7.940089854535901e+01 -7.945198670709752e+01 -7.950309780756868e+01 -7.955423180605224e+01 -7.960538872303847e+01 + -7.965656859466247e+01 -7.970777145842827e+01 -7.975899733555858e+01 -7.981024618078136e+01 -7.986151795697417e+01 + -7.991281272610696e+01 -7.996413054847572e+01 -8.001547137858779e+01 -8.006683517069925e+01 -8.011822198384908e+01 + -8.016963187855384e+01 -8.022106481645797e+01 -8.027252075224854e+01 -8.032399971165485e+01 -8.037550173585385e+01 + -8.042702685677139e+01 -8.047857509055929e+01 -8.053014639952434e+01 -8.058174075328817e+01 -8.063335820457638e+01 + -8.068499880610621e+01 -8.073666252745771e+01 -8.078834933088126e+01 -8.084005923244513e+01 -8.089179226408041e+01 + -8.094354846735196e+01 -8.099532786819320e+01 -8.104713042037783e+01 -8.109895608507813e+01 -8.115080492521992e+01 + -8.120267700205356e+01 -8.125457226837462e+01 -8.130649067623317e+01 -8.135843228315183e+01 -8.141039715010918e+01 + -8.146238524643556e+01 -8.151439653208425e+01 -8.156643102114791e+01 -8.161848874447259e+01 -8.167056974577932e+01 + -8.172267405314662e+01 -8.177480161920819e+01 -8.182695240289546e+01 -8.187912646377457e+01 -8.193132386298609e+01 + -8.198354456733288e+01 -8.203578853472443e+01 -8.208805578183410e+01 -8.214034634197473e+01 -8.219266025625411e+01 + -8.224499755029157e+01 -8.229735817995817e+01 -8.234974210798764e+01 -8.240214939431286e+01 -8.245458009683706e+01 + -8.250703416814667e+01 -8.255951156203467e+01 -8.261201234243612e+01 -8.266453657428882e+01 -8.271708421639993e+01 + -8.276965521981012e+01 -8.282224961062391e+01 -8.287486743131451e+01 -8.292750871476633e+01 -8.298017347733835e+01 + -8.303286167887651e+01 -8.308557328775250e+01 -8.313830836295337e+01 -8.319106696215761e+01 -8.324384904719405e+01 + -8.329665457280116e+01 -8.334948356120523e+01 -8.340233605179664e+01 -8.345521208513452e+01 -8.350811168407860e+01 + -8.356103479952203e+01 -8.361398139085040e+01 -8.366695152338559e+01 -8.371994526125894e+01 -8.377296255790387e+01 + -8.382600336547402e+01 -8.387906774170159e+01 -8.393215574692768e+01 -8.398526734635097e+01 -8.403840249721476e+01 + -8.409156122008268e+01 -8.414474355213920e+01 -8.419794953373223e+01 -8.425117918830632e+01 -8.430443246852916e+01 + -8.435770933516140e+01 -8.441100985211256e+01 -8.446433408298962e+01 -8.451768198704093e+01 -8.457105351533237e+01 + -8.462444869055821e+01 -8.467786755329161e+01 -8.473131014399300e+01 -8.478477648534972e+01 -8.483826652906932e+01 + -8.489178023573824e+01 -8.494531767243778e+01 -8.499887890373510e+01 -8.505246387764603e+01 -8.510607254206460e+01 + -8.515970496094809e+01 -8.521336120130535e+01 -8.526704122628841e+01 -8.532074498941530e+01 -8.537447250952404e+01 + -8.542822382319736e+01 -8.548199897267675e+01 -8.553579798342942e+01 -8.558962080816578e+01 -8.564346740685433e+01 + -8.569733784125194e+01 -8.575123217367282e+01 -8.580515036687339e+01 -8.585909237532205e+01 -8.591305821989287e+01 + -8.596704793875205e+01 -8.602106157282915e+01 -8.607509914567974e+01 -8.612916060859980e+01 -8.618324592155754e+01 + -8.623735515146925e+01 -8.629148836331387e+01 -8.634564550737286e+01 -8.639982653295500e+01 -8.645403150017543e+01 + -8.650826047252751e+01 -8.656251341621210e+01 -8.661679028858919e+01 -8.667109110894766e+01 -8.672541591317201e+01 + -8.677976474159972e+01 -8.683413761829634e+01 -8.688853449778628e+01 -8.694295534179228e+01 -8.699740021037117e+01 + -8.705186916402354e+01 -8.710636216669133e+01 -8.716087917454270e+01 -8.721542020920894e+01 -8.726998530877070e+01 + -8.732457451164281e+01 -8.737918783967393e+01 -8.743382524811331e+01 -8.748848670054353e+01 -8.754317226047976e+01 + -8.759788198894785e+01 -8.765261583708421e+01 -8.770737375634857e+01 -8.776215580938322e+01 -8.781696206132678e+01 + -8.787179247612183e+01 -8.792664700860111e+01 -8.798152567835336e+01 -8.803642852212045e+01 -8.809135558050070e+01 + -8.814630687756171e+01 -8.820128236739042e+01 -8.825628201129771e+01 -8.831130586947003e+01 -8.836635400284558e+01 + -8.842142637649435e+01 -8.847652294770472e+01 -8.853164373850628e+01 -8.858678878695027e+01 -8.864195813043362e+01 + -8.869715178945941e+01 -8.875236971760948e+01 -8.880761187808301e+01 -8.886287833946902e+01 -8.891816916696094e+01 + -8.897348430677987e+01 -8.902882370531137e+01 -8.908418742857141e+01 -8.913957554536425e+01 -8.919498801601753e+01 + -8.925042479199006e+01 -8.930588589774098e+01 -8.936137137472512e+01 -8.941688125937962e+01 -8.947241557120560e+01 + -8.952797426697802e+01 -8.958355731201681e+01 -8.963916476854843e+01 -8.969479669732335e+01 -8.975045305628245e+01 + -8.980613379692392e+01 -8.986183894778455e+01 -8.991756855389235e+01 -8.997332264920152e+01 -9.002910125051302e+01 + -9.008490431708829e+01 -9.014073181666647e+01 -9.019658380843681e+01 -9.025246034941333e+01 -9.030836139645970e+01 + -9.036428690661128e+01 -9.042023693773967e+01 -9.047621154925669e+01 -9.053221070589892e+01 -9.058823436476921e+01 + -9.064428254711031e+01 -9.070035529106499e+01 -9.075645263823618e+01 -9.081257461289793e+01 -9.086872116654884e+01 + -9.092489225918972e+01 -9.098108795760594e+01 -9.103730832657459e+01 -9.109355331605536e+01 -9.114982287548730e+01 + -9.120611706704364e+01 -9.126243595579022e+01 -9.131877950563008e+01 -9.137514767186437e+01 -9.143154047654943e+01 + -9.148795795857168e+01 -9.154440015738282e+01 -9.160086709537343e+01 -9.165735872612346e+01 -9.171387501169491e+01 + -9.177041601688784e+01 -9.182698180564800e+01 -9.188357233576582e+01 -9.194018755741556e+01 -9.199682749646104e+01 + -9.205349219658670e+01 -9.211018169707003e+01 -9.216689601912306e+01 -9.222363511610273e+01 -9.228039895018067e+01 + -9.233718758664240e+01 -9.239400108840672e+01 -9.245083940581294e+01 -9.250770248979978e+01 -9.256459040628322e+01 + -9.262150322244982e+01 -9.267844089559186e+01 -9.273540337476760e+01 -9.279239068599267e+01 -9.284940287335907e+01 + -9.290643997630693e+01 -9.296350201607783e+01 -9.302058894577094e+01 -9.307770072730455e+01 -9.313483742601555e+01 + -9.319199910633068e+01 -9.324918572561810e+01 -9.330639723351504e+01 -9.336363365579297e+01 -9.342089503640302e+01 + -9.347818141588093e+01 -9.353549281584256e+01 -9.359282918563940e+01 -9.365019048477910e+01 -9.370757678565749e+01 + -9.376498815769901e+01 -9.382242454555492e+01 -9.387988589305337e+01 -9.393737226550313e+01 -9.399488373202897e+01 + -9.405242025553964e+01 -9.410998178945039e+01 -9.416756835541781e+01 -9.422517999301114e+01 -9.428281674520871e+01 + -9.434047863667399e+01 -9.439816561540189e+01 -9.445587763836596e+01 -9.451361477512259e+01 -9.457137709520302e+01 + -9.462916455545547e+01 -9.468697710379740e+01 -9.474481476510589e+01 -9.480267758244509e+01 -9.486056559466863e+01 + -9.491847882335075e+01 -9.497641722515867e+01 -9.503438076487508e+01 -9.509236950465109e+01 -9.515038350409563e+01 + -9.520842271528107e+01 -9.526648709103007e+01 -9.532457669470300e+01 -9.538269159175374e+01 -9.544083174547335e+01 + -9.549899710997526e+01 -9.555718770482461e+01 -9.561540356780063e+01 -9.567364474408794e+01 -9.573191126075703e+01 + -9.579020306501620e+01 -9.584852011272490e+01 -9.590686247420874e+01 -9.596523021978578e+01 -9.602362330527772e+01 + -9.608204167783254e+01 -9.614048536439948e+01 -9.619895441016116e+01 -9.625744885343293e+01 -9.631596871403326e+01 + -9.637451394466026e+01 -9.643308450797647e+01 -9.649168047362274e+01 -9.655030190767742e+01 -9.660894875499127e+01 + -9.666762096089710e+01 -9.672631859388268e+01 -9.678504172537357e+01 -9.684379031539257e+01 -9.690256431417546e+01 + -9.696136374421286e+01 -9.702018864639355e+01 -9.707903906294442e+01 -9.713791501832830e+01 -9.719681646461351e+01 + -9.725574336170810e+01 -9.731469577327378e+01 -9.737367376351882e+01 -9.743267729508464e+01 -9.749170632178308e+01 + -9.755076086367355e+01 -9.760984095895955e+01 -9.766894665217343e+01 -9.772807797034233e+01 -9.778723486414395e+01 + -9.784641729236439e+01 -9.790562532257231e+01 -9.796485902036660e+01 -9.802411833468516e+01 -9.808340321418262e+01 + -9.814271372304191e+01 -9.820204992860188e+01 -9.826141179529722e+01 -9.832079927766843e+01 -9.838021239358226e+01 + -9.843965117935535e+01 -9.849911568177785e+01 -9.855860593025675e+01 -9.861812187419362e+01 -9.867766347002308e+01 + -9.873723078231735e+01 -9.879682387670165e+01 -9.885644271487612e+01 -9.891608724974174e+01 -9.897575750292785e+01 + -9.903545351466867e+01 -9.909517533088989e+01 -9.915492297862031e+01 -9.921469640360959e+01 -9.927449556058966e+01 + -9.933432052149955e+01 -9.939417135686639e+01 -9.945404801436261e+01 -9.951395044077229e+01 -9.957387870218038e+01 + -9.963383286719130e+01 -9.969381289518709e+01 -9.975381873630593e+01 -9.981385041293248e+01 -9.987390796877466e+01 + -9.993399146058783e+01 -9.999410091983435e+01 -1.000542362637563e+02 -1.001143974249114e+02 -1.001745845113392e+02 + -1.002347976270743e+02 -1.002950366846517e+02 -1.003553015922550e+02 -1.004155924321621e+02 -1.004759093011103e+02 + -1.005362521795820e+02 -1.005966210292817e+02 -1.006570158530568e+02 -1.007174366671700e+02 -1.007778835004040e+02 + -1.008383563749385e+02 -1.008988552740233e+02 -1.009593801813489e+02 -1.010199311212978e+02 -1.010805081231472e+02 + -1.011411111950619e+02 -1.012017403376325e+02 -1.012623955422635e+02 -1.013230768099676e+02 -1.013837841893743e+02 + -1.014445177207514e+02 -1.015052773633014e+02 -1.015660630775449e+02 -1.016268749103392e+02 -1.016877129150088e+02 + -1.017485770844115e+02 -1.018094673966629e+02 -1.018703838313761e+02 -1.019313263923028e+02 -1.019922951782496e+02 + -1.020532902664119e+02 -1.021143115524854e+02 -1.021753589342455e+02 -1.022364324992857e+02 -1.022975323519374e+02 + -1.023586584736673e+02 -1.024198108268543e+02 -1.024809894203941e+02 -1.025421942728475e+02 -1.026034253949216e+02 + -1.026646827901934e+02 -1.027259664415750e+02 -1.027872763473731e+02 -1.028486125881369e+02 -1.029099752254547e+02 + -1.029713641628286e+02 -1.030327793161952e+02 -1.030942208093169e+02 -1.031556887637190e+02 -1.032171830841550e+02 + -1.032787036718354e+02 -1.033402506305696e+02 -1.034018240681317e+02 -1.034634239055545e+02 -1.035250500515010e+02 + -1.035867025518952e+02 -1.036483814821213e+02 -1.037100868981441e+02 -1.037718188237329e+02 -1.038335771732939e+02 + -1.038953618747522e+02 -1.039571730194689e+02 -1.040190107055651e+02 -1.040808748947658e+02 -1.041427655331822e+02 + -1.042046826408667e+02 -1.042666262524425e+02 -1.043285963868752e+02 -1.043905930564436e+02 -1.044526162623378e+02 + -1.045146660069125e+02 -1.045767423082721e+02 -1.046388451777543e+02 -1.047009745838822e+02 -1.047631305085241e+02 + -1.048253130297424e+02 -1.048875222165416e+02 -1.049497580055002e+02 -1.050120203310284e+02 -1.050743092512860e+02 + -1.051366248384456e+02 -1.051989670969791e+02 -1.052613360137520e+02 -1.053237315729033e+02 -1.053861537661844e+02 + -1.054486026185219e+02 -1.055110781583045e+02 -1.055735803945944e+02 -1.056361093274371e+02 -1.056986649401382e+02 + -1.057612472323176e+02 -1.058238562855892e+02 -1.058864921618116e+02 -1.059491547618286e+02 -1.060118440001799e+02 + -1.060745600072047e+02 -1.061373029070868e+02 -1.062000725835928e+02 -1.062628689188559e+02 -1.063256920288941e+02 + -1.063885420424685e+02 -1.064514189054312e+02 -1.065143225392365e+02 -1.065772529506575e+02 -1.066402101774261e+02 + -1.067031942957903e+02 -1.067662053568374e+02 -1.068292432724951e+02 -1.068923079625714e+02 -1.069553995175528e+02 + -1.070185180380394e+02 -1.070816634944072e+02 -1.071448358336418e+02 -1.072080350393896e+02 -1.072712611247882e+02 + -1.073345141842783e+02 -1.073977942922143e+02 -1.074611013613008e+02 -1.075244353055826e+02 -1.075877962061142e+02 + -1.076511841502191e+02 -1.077145990832866e+02 -1.077780409492339e+02 -1.078415098280245e+02 -1.079050057992970e+02 + -1.079685288053471e+02 -1.080320787786834e+02 -1.080956557500093e+02 -1.081592597729443e+02 -1.082228908945775e+02 + -1.082865491424036e+02 -1.083502344720692e+02 -1.084139468448718e+02 -1.084776863165616e+02 -1.085414529440200e+02 + -1.086052466942038e+02 -1.086690675238350e+02 -1.087329154386204e+02 -1.087967904674474e+02 -1.088606926829425e+02 + -1.089246221377382e+02 -1.089885787607543e+02 -1.090525624876805e+02 -1.091165734050004e+02 -1.091806115963225e+02 + -1.092446769829633e+02 -1.093087694909110e+02 -1.093728892271333e+02 -1.094370362953419e+02 -1.095012106052476e+02 + -1.095654120623545e+02 -1.096296407493415e+02 -1.096938967647426e+02 -1.097581800933404e+02 -1.098224906984946e+02 + -1.098868285716250e+02 -1.099511937236656e+02 -1.100155862155477e+02 -1.100800060933800e+02 -1.101444532939841e+02 + -1.102089277564002e+02 -1.102734295378303e+02 -1.103379587096266e+02 -1.104025152815812e+02 -1.104670992426730e+02 + -1.105317105601886e+02 -1.105963492199813e+02 -1.106610153038629e+02 -1.107257088820756e+02 -1.107904298826226e+02 + -1.108551782361634e+02 -1.109199540262203e+02 -1.109847573373186e+02 -1.110495881051325e+02 -1.111144462586115e+02 + -1.111793318486534e+02 -1.112442449476576e+02 -1.113091855920787e+02 -1.113741537899001e+02 -1.114391494711626e+02 + -1.115041725824562e+02 -1.115692232145109e+02 -1.116343014623147e+02 -1.116994072937479e+02 -1.117645406555522e+02 + -1.118297015370191e+02 -1.118948899532702e+02 -1.119601059801944e+02 -1.120253496750247e+02 -1.120906209596036e+02 + -1.121559197660155e+02 -1.122212462027017e+02 -1.122866003728487e+02 -1.123519821822644e+02 -1.124173915349786e+02 + -1.124828285252852e+02 -1.125482932599049e+02 -1.126137857050017e+02 -1.126793058037530e+02 -1.127448535479451e+02 + -1.128104289543148e+02 -1.128760320907921e+02 -1.129416630123176e+02 -1.130073216706816e+02 -1.130730080183262e+02 + -1.131387221134510e+02 -1.132044640167948e+02 -1.132702336934948e+02 -1.133360310978225e+02 -1.134018562361866e+02 + -1.134677091387784e+02 -1.135335898787815e+02 -1.135994985091588e+02 -1.136654349589990e+02 -1.137313991629182e+02 + -1.137973912015162e+02 -1.138634111582333e+02 -1.139294589818884e+02 -1.139955346168527e+02 -1.140616381243277e+02 + -1.141277695680233e+02 -1.141939289048548e+02 -1.142601160860919e+02 -1.143263311472162e+02 -1.143925741390390e+02 + -1.144588450894802e+02 -1.145251440101338e+02 -1.145914708701818e+02 -1.146578256494022e+02 -1.147242084123678e+02 + -1.147906192149256e+02 -1.148570579932248e+02 -1.149235246826633e+02 -1.149900193353325e+02 -1.150565420227369e+02 + -1.151230927773426e+02 -1.151896716067799e+02 -1.152562784583746e+02 -1.153229132947855e+02 -1.153895762003063e+02 + -1.154562672526404e+02 -1.155229863814943e+02 -1.155897335150450e+02 -1.156565087233475e+02 -1.157233120892246e+02 + -1.157901436046917e+02 -1.158570032371645e+02 -1.159238909464663e+02 -1.159908067231330e+02 -1.160577506881430e+02 + -1.161247229415995e+02 -1.161917233696630e+02 -1.162587518588770e+02 -1.163258085112608e+02 -1.163928934406831e+02 + -1.164600065929374e+02 -1.165271479034755e+02 -1.165943174344564e+02 -1.166615152526160e+02 -1.167287413162901e+02 + -1.167959955757904e+02 -1.168632780577301e+02 -1.169305888112216e+02 -1.169979278990717e+02 -1.170652953548001e+02 + -1.171326910810820e+02 -1.172001149975291e+02 -1.172675672223445e+02 -1.173350478778825e+02 -1.174025569045121e+02 + -1.174700942215011e+02 -1.175376598456954e+02 -1.176052538191002e+02 -1.176728761867799e+02 -1.177405269796691e+02 + -1.178082061691247e+02 -1.178759137299273e+02 -1.179436497101298e+02 -1.180114141509050e+02 -1.180792069926326e+02 + -1.181470281872303e+02 -1.182148778335583e+02 -1.182827560287664e+02 -1.183506627162192e+02 -1.184185978220269e+02 + -1.184865613570652e+02 -1.185545533602401e+02 -1.186225738978121e+02 -1.186906230193939e+02 -1.187587006806511e+02 + -1.188268068350639e+02 -1.188949415213182e+02 -1.189631047837780e+02 -1.190312966043158e+02 -1.190995169567162e+02 + -1.191677658449030e+02 -1.192360432941998e+02 -1.193043493853908e+02 -1.193726841751893e+02 -1.194410475685670e+02 + -1.195094394794060e+02 -1.195778600089746e+02 -1.196463092648311e+02 -1.197147871923100e+02 -1.197832937276135e+02 + -1.198518289326376e+02 -1.199203928745778e+02 -1.199889855161324e+02 -1.200576068078755e+02 -1.201262567563797e+02 + -1.201949353935382e+02 -1.202636427965272e+02 -1.203323790196208e+02 -1.204011439802014e+02 -1.204699376081542e+02 + -1.205387600202684e+02 -1.206076113241917e+02 -1.206764914041025e+02 -1.207454001431820e+02 -1.208143376440890e+02 + -1.208833040296615e+02 -1.209522992839752e+02 -1.210213233653680e+02 -1.210903762679893e+02 -1.211594580022500e+02 + -1.212285686077949e+02 -1.212977081155049e+02 -1.213668764919694e+02 -1.214360737100132e+02 -1.215052998316942e+02 + -1.215745549154533e+02 -1.216438389160294e+02 -1.217131517838345e+02 -1.217824935556734e+02 -1.218518642837182e+02 + -1.219212639952166e+02 -1.219906927020717e+02 -1.220601503797327e+02 -1.221296370078328e+02 -1.221991526191948e+02 + -1.222686972509000e+02 -1.223382709038720e+02 -1.224078735702578e+02 -1.224775052432531e+02 -1.225471659287695e+02 + -1.226168556825330e+02 -1.226865745477072e+02 -1.227563224673916e+02 -1.228260993926653e+02 -1.228959054065903e+02 + -1.229657405910973e+02 -1.230356048916106e+02 -1.231054982500379e+02 -1.231754207307278e+02 -1.232453724007864e+02 + -1.233153532159101e+02 -1.233853631242201e+02 -1.234554021549459e+02 -1.235254703591199e+02 -1.235955677938801e+02 + -1.236656944915691e+02 -1.237358503792446e+02 -1.238060353939673e+02 -1.238762496180971e+02 -1.239464931371069e+02 + -1.240167659036240e+02 -1.240870678602586e+02 -1.241573990423949e+02 -1.242277595040581e+02 -1.242981492810638e+02 + -1.243685683872523e+02 -1.244390167667736e+02 -1.245094943779347e+02 -1.245800013053605e+02 -1.246505376299316e+02 + -1.247211032912332e+02 -1.247916982296097e+02 -1.248623225297382e+02 -1.249329762770640e+02 -1.250036594157741e+02 + -1.250743718736609e+02 -1.251451136541969e+02 -1.252158847947410e+02 -1.252866853925174e+02 -1.253575155184925e+02 + -1.254283750787370e+02 -1.254992639825418e+02 -1.255701823169751e+02 -1.256411301759969e+02 -1.257121075033584e+02 + -1.257831142369608e+02 -1.258541504415142e+02 -1.259252161922362e+02 -1.259963114795672e+02 -1.260674362758903e+02 + -1.261385905661348e+02 -1.262097743537985e+02 -1.262809877041053e+02 -1.263522306696565e+02 -1.264235031908370e+02 + -1.264948052148923e+02 -1.265661368287249e+02 -1.266374981169807e+02 -1.267088890156212e+02 -1.267803094502130e+02 + -1.268517594534262e+02 -1.269232390831601e+02 -1.269947483911282e+02 -1.270662874069690e+02 -1.271378560782095e+02 + -1.272094543594662e+02 -1.272810823158284e+02 -1.273527400123002e+02 -1.274244274030747e+02 -1.274961444355319e+02 + -1.275678911406106e+02 -1.276396675704015e+02 -1.277114737780431e+02 -1.277833097950603e+02 -1.278551755654751e+02 + -1.279270710424012e+02 -1.279989963028243e+02 -1.280709514152536e+02 -1.281429362904217e+02 -1.282149508513121e+02 + -1.282869952276877e+02 -1.283590695463467e+02 -1.284311737154509e+02 -1.285033076302067e+02 -1.285754713526335e+02 + -1.286476649682441e+02 -1.287198884897120e+02 -1.287921419051992e+02 -1.288644251776617e+02 -1.289367382880697e+02 + -1.290090813146567e+02 -1.290814543319980e+02 -1.291538573027727e+02 -1.292262901737162e+02 -1.292987529396840e+02 + -1.293712456190937e+02 -1.294437682764910e+02 -1.295163209673579e+02 -1.295889036647941e+02 -1.296615163353197e+02 + -1.297341590015173e+02 -1.298068316903185e+02 -1.298795343899871e+02 -1.299522670904091e+02 -1.300250298266263e+02 + -1.300978226354063e+02 -1.301706455152632e+02 -1.302434984561237e+02 -1.303163814518184e+02 -1.303892945098205e+02 + -1.304622376882688e+02 -1.305352110313897e+02 -1.306082144770936e+02 -1.306812479731976e+02 -1.307543116134598e+02 + -1.308274054850011e+02 -1.309005295024521e+02 -1.309736835845235e+02 -1.310468678387340e+02 -1.311200823754845e+02 + -1.311933271278942e+02 -1.312666020134129e+02 -1.313399070640916e+02 -1.314132423401880e+02 -1.314866079001839e+02 + -1.315600037753056e+02 -1.316334298895329e+02 -1.317068861777292e+02 -1.317803727255405e+02 -1.318538896215189e+02 + -1.319274368150577e+02 -1.320010142454794e+02 -1.320746219509807e+02 -1.321482599879661e+02 -1.322219283867981e+02 + -1.322956271602158e+02 -1.323693562765047e+02 -1.324431157110688e+02 -1.325169055122373e+02 -1.325907257242561e+02 + -1.326645763021127e+02 -1.327384572099461e+02 -1.328123685377604e+02 -1.328863103680995e+02 -1.329602826278048e+02 + -1.330342852393407e+02 -1.331083182633673e+02 -1.331823817787306e+02 -1.332564757988239e+02 -1.333306003141445e+02 + -1.334047552890586e+02 -1.334789407033280e+02 -1.335531566244299e+02 -1.336274031130300e+02 -1.337016801148342e+02 + -1.337759875748336e+02 -1.338503255501201e+02 -1.339246941130952e+02 -1.339990932852997e+02 -1.340735230609586e+02 + -1.341479833758948e+02 -1.342224741891434e+02 -1.342969956109889e+02 -1.343715477431406e+02 -1.344461305017541e+02 + -1.345207438015131e+02 -1.345953877367626e+02 -1.346700624038786e+02 -1.347447677276981e+02 -1.348195036263442e+02 + -1.348942701626209e+02 -1.349690674171868e+02 -1.350438953974369e+02 -1.351187540921076e+02 -1.351936434885642e+02 + -1.352685635848754e+02 -1.353435144232942e+02 -1.354184960414874e+02 -1.354935084145923e+02 -1.355685515128237e+02 + -1.356436253492364e+02 -1.357187299541088e+02 -1.357938653837732e+02 -1.358690316768758e+02 -1.359442287752637e+02 + -1.360194566279880e+02 -1.360947153097144e+02 -1.361700048911278e+02 -1.362453253013760e+02 -1.363206764782614e+02 + -1.363960585357406e+02 -1.364714715821978e+02 -1.365469155275740e+02 -1.366223902703805e+02 -1.366978958618521e+02 + -1.367734323848502e+02 -1.368489998960226e+02 -1.369245984210613e+02 -1.370002278880492e+02 -1.370758882331093e+02 + -1.371515795221331e+02 -1.372273018270698e+02 -1.373030551143317e+02 -1.373788393429953e+02 -1.374546545483291e+02 + -1.375305007816427e+02 -1.376063780822184e+02 -1.376822864668756e+02 -1.377582258746108e+02 -1.378341962588316e+02 + -1.379101977084133e+02 -1.379862303093919e+02 -1.380622940009784e+02 -1.381383887192652e+02 -1.382145145346940e+02 + -1.382906715205862e+02 -1.383668596274320e+02 -1.384430787972570e+02 -1.385193290610606e+02 -1.385956104734610e+02 + -1.386719230945808e+02 -1.387482669582360e+02 -1.388246419875133e+02 -1.389010481148665e+02 -1.389774854209464e+02 + -1.390539539951986e+02 -1.391304538140523e+02 -1.392069848343242e+02 -1.392835470473980e+02 -1.393601404693719e+02 + -1.394367651806349e+02 -1.395134212422815e+02 -1.395901085739362e+02 -1.396668271002043e+02 -1.397435769070855e+02 + -1.398203580874878e+02 -1.398971706005607e+02 -1.399740143977720e+02 -1.400508895336226e+02 -1.401277960614956e+02 + -1.402047339272718e+02 -1.402817030764181e+02 -1.403587035602461e+02 -1.404357354502877e+02 -1.405127987931110e+02 + -1.405898936026113e+02 -1.406670197869564e+02 -1.407441772794584e+02 -1.408213662197336e+02 -1.408985867371466e+02 + -1.409758387137537e+02 -1.410531220224061e+02 -1.411304367464428e+02 -1.412077829961380e+02 -1.412851607790223e+02 + -1.413625700771281e+02 -1.414400108732392e+02 -1.415174831646232e+02 -1.415949870057306e+02 -1.416725224388105e+02 + -1.417500894001226e+02 -1.418276878351835e+02 -1.419053178325258e+02 -1.419829794809226e+02 -1.420606727270934e+02 + -1.421383975074728e+02 -1.422161538594082e+02 -1.422939418408956e+02 -1.423717614916131e+02 -1.424496128273150e+02 + -1.425274957863782e+02 -1.426054103213069e+02 -1.426833565184944e+02 -1.427613344645970e+02 -1.428393441134355e+02 + -1.429173854035838e+02 -1.429954583454632e+02 -1.430735629773860e+02 -1.431516993773805e+02 -1.432298676007922e+02 + -1.433080675725197e+02 -1.433862992191345e+02 -1.434645626043482e+02 -1.435428578032951e+02 -1.436211847996638e+02 + -1.436995435672099e+02 -1.437779341314036e+02 -1.438563565210897e+02 -1.439348107268960e+02 -1.440132967358192e+02 + -1.440918145585468e+02 -1.441703642214681e+02 -1.442489457900865e+02 -1.443275593072134e+02 -1.444062046857781e+02 + -1.444848818522611e+02 -1.445635909172288e+02 -1.446423319927847e+02 -1.447211050130976e+02 -1.447999098925679e+02 + -1.448787466444589e+02 -1.449576153140356e+02 -1.450365159757091e+02 -1.451154486823820e+02 -1.451944133717774e+02 + -1.452734099863848e+02 -1.453524386029381e+02 -1.454314992962476e+02 -1.455105919991844e+02 -1.455897166474813e+02 + -1.456688733302556e+02 -1.457480621396693e+02 -1.458272830266799e+02 -1.459065359271370e+02 -1.459858208576615e+02 + -1.460651378591126e+02 -1.461444869885314e+02 -1.462238682831965e+02 -1.463032816851561e+02 -1.463827271416525e+02 + -1.464622047159361e+02 -1.465417144784923e+02 -1.466212564127396e+02 -1.467008304928943e+02 -1.467804367434297e+02 + -1.468600751934606e+02 -1.469397458404120e+02 -1.470194486722770e+02 -1.470991836710121e+02 -1.471789508433917e+02 + -1.472587503015001e+02 -1.473385821300154e+02 -1.474184461986837e+02 -1.474983423870870e+02 -1.475782708290815e+02 + -1.476582316674545e+02 -1.477382248264445e+02 -1.478182502096616e+02 -1.478983078567520e+02 -1.479783978350921e+02 + -1.480585201869469e+02 -1.481386749269736e+02 -1.482188619845118e+02 -1.482990813088785e+02 -1.483793330146163e+02 + -1.484596172099193e+02 -1.485399338123612e+02 -1.486202827323657e+02 -1.487006640423751e+02 -1.487810778248495e+02 + -1.488615240403001e+02 -1.489420026412511e+02 -1.490225136702235e+02 -1.491030571832025e+02 -1.491836332000337e+02 + -1.492642417202360e+02 -1.493448826981615e+02 -1.494255561054278e+02 -1.495062620278810e+02 -1.495870005487025e+02 + -1.496677716261896e+02 -1.497485751994623e+02 -1.498294112558179e+02 -1.499102798158717e+02 -1.499911809853331e+02 + -1.500721148441144e+02 -1.501530812838450e+02 -1.502340802026938e+02 -1.503151117132690e+02 -1.503961759364751e+02 + -1.504772728119622e+02 -1.505584022645880e+02 -1.506395643412949e+02 -1.507207591024668e+02 -1.508019865401696e+02 + -1.508832466324269e+02 -1.509645393694111e+02 -1.510458647628492e+02 -1.511272228985386e+02 -1.512086138412552e+02 + -1.512900374976176e+02 -1.513714937855876e+02 -1.514529828266537e+02 -1.515345047392310e+02 -1.516160594259147e+02 + -1.516976467776822e+02 -1.517792668548592e+02 -1.518609197460578e+02 -1.519426054836894e+02 -1.520243240750476e+02 + -1.521060754831553e+02 -1.521878596792744e+02 -1.522696767118938e+02 -1.523515266305248e+02 -1.524334094115421e+02 + -1.525153250314230e+02 -1.525972735401888e+02 -1.526792549864990e+02 -1.527612693400200e+02 -1.528433165631959e+02 + -1.529253966685747e+02 -1.530075096900777e+02 -1.530896556970147e+02 -1.531718347321965e+02 -1.532540466970516e+02 + -1.533362915133235e+02 -1.534185693253995e+02 -1.535008802693854e+02 -1.535832242256197e+02 -1.536656010621809e+02 + -1.537480108538752e+02 -1.538304537113657e+02 -1.539129296820158e+02 -1.539954387715506e+02 -1.540779808824423e+02 + -1.541605559457948e+02 -1.542431641104905e+02 -1.543258055115917e+02 -1.544084800111010e+02 -1.544911874726015e+02 + -1.545739280390565e+02 -1.546567018609975e+02 -1.547395088398511e+02 -1.548223488576198e+02 -1.549052219677139e+02 + -1.549881282595875e+02 -1.550710677954614e+02 -1.551540406026988e+02 -1.552370465964632e+02 -1.553200857053796e+02 + -1.554031580241178e+02 -1.554862636500489e+02 -1.555694025253043e+02 -1.556525745801794e+02 -1.557357798528659e+02 + -1.558190184045264e+02 -1.559022902803117e+02 -1.559855954979769e+02 -1.560689339817060e+02 -1.561523056771075e+02 + -1.562357107090587e+02 -1.563191491909100e+02 -1.564026210106382e+02 -1.564861260558312e+02 -1.565696644378976e+02 + -1.566532362813955e+02 -1.567368415396626e+02 -1.568204801387562e+02 -1.569041520668287e+02 -1.569878573487146e+02 + -1.570715960938785e+02 -1.571553683828581e+02 -1.572391740958522e+02 -1.573230131265335e+02 -1.574068856228085e+02 + -1.574907917295132e+02 -1.575747313249683e+02 -1.576587042737324e+02 -1.577427106518309e+02 -1.578267505715277e+02 + -1.579108240785769e+02 -1.579949311783184e+02 -1.580790717809458e+02 -1.581632458187553e+02 -1.582474534075981e+02 + -1.583316946623155e+02 -1.584159695101536e+02 -1.585002778727259e+02 -1.585846198367120e+02 -1.586689954874005e+02 + -1.587534047394542e+02 -1.588378475061590e+02 -1.589223238659185e+02 -1.590068339195322e+02 -1.590913776922658e+02 + -1.591759551748261e+02 -1.592605662952183e+02 -1.593452110061037e+02 -1.594298894214712e+02 -1.595146016508511e+02 + -1.595993476246111e+02 -1.596841272537272e+02 -1.597689405507699e+02 -1.598537875632453e+02 -1.599386683768111e+02 + -1.600235830481832e+02 -1.601085314801616e+02 -1.601935135899282e+02 -1.602785295061083e+02 -1.603635793509372e+02 + -1.604486630096468e+02 -1.605337803660765e+02 -1.606189315354990e+02 -1.607041166452176e+02 -1.607893356392255e+02 + -1.608745884397152e+02 -1.609598750649831e+02 -1.610451955612870e+02 -1.611305499906227e+02 -1.612159383917271e+02 + -1.613013606945609e+02 -1.613868168398436e+02 -1.614723069201057e+02 -1.615578310304217e+02 -1.616433891242326e+02 + -1.617289811339727e+02 -1.618146070496823e+02 -1.619002668955830e+02 -1.619859607750138e+02 -1.620716887676450e+02 + -1.621574507793529e+02 -1.622432467219253e+02 -1.623290767045893e+02 -1.624149408340039e+02 -1.625008390091176e+02 + -1.625867711331680e+02 -1.626727373342588e+02 -1.627587377384768e+02 -1.628447722389764e+02 -1.629308407201184e+02 + -1.630169432640222e+02 -1.631030799800713e+02 -1.631892508889492e+02 -1.632754559784962e+02 -1.633616951938801e+02 + -1.634479685044198e+02 -1.635342760187116e+02 -1.636206178291233e+02 -1.637069938238325e+02 -1.637934038942077e+02 + -1.638798481485683e+02 -1.639663267112721e+02 -1.640528395538795e+02 -1.641393866180353e+02 -1.642259678785196e+02 + -1.643125833411851e+02 -1.643992331030405e+02 -1.644859172470150e+02 -1.645726357085657e+02 -1.646593884180614e+02 + -1.647461754329907e+02 -1.648329968179324e+02 -1.649198525387065e+02 -1.650067425502886e+02 -1.650936668630355e+02 + -1.651806255134507e+02 -1.652676185872448e+02 -1.653546461444497e+02 -1.654417080931755e+02 -1.655288043499995e+02 + -1.656159350172886e+02 -1.657031001994683e+02 -1.657902998234105e+02 -1.658775338117127e+02 -1.659648022474274e+02 + -1.660521052162188e+02 -1.661394426537408e+02 -1.662268144894047e+02 -1.663142207776613e+02 -1.664016615975541e+02 + -1.664891370014617e+02 -1.665766470055737e+02 -1.666641915079906e+02 -1.667517704334961e+02 -1.668393839316945e+02 + -1.669270321420214e+02 -1.670147149384157e+02 -1.671024321837371e+02 -1.671901839620226e+02 -1.672779703889409e+02 + -1.673657914855093e+02 -1.674536472385115e+02 -1.675415375924466e+02 -1.676294625158688e+02 -1.677174221158364e+02 + -1.678054164853866e+02 -1.678934455229663e+02 -1.679815091339810e+02 -1.680696074462591e+02 -1.681577405863894e+02 + -1.682459084535819e+02 -1.683341109324726e+02 -1.684223480767776e+02 -1.685106199767677e+02 -1.685989266998525e+02 + -1.686872682758898e+02 -1.687756446073924e+02 -1.688640556163956e+02 -1.689525014303699e+02 -1.690409821718389e+02 + -1.691294977381033e+02 -1.692180480141565e+02 -1.693066330609834e+02 -1.693952529706734e+02 -1.694839077837423e+02 + -1.695725975104607e+02 -1.696613220916933e+02 -1.697500814887782e+02 -1.698388758143547e+02 -1.699277051650943e+02 + -1.700165694224996e+02 -1.701054684738952e+02 -1.701944024450633e+02 -1.702833714670375e+02 -1.703723754534025e+02 + -1.704614143033400e+02 -1.705504880758685e+02 -1.706395968591658e+02 -1.707287406982126e+02 -1.708179196055015e+02 + -1.709071335067704e+02 -1.709963823462651e+02 -1.710856662290167e+02 -1.711749852543236e+02 -1.712643393377691e+02 + -1.713537283867857e+02 -1.714431524599174e+02 -1.715326116432521e+02 -1.716221059819435e+02 -1.717116354891412e+02 + -1.718012000909151e+02 -1.718907997312464e+02 -1.719804345128430e+02 -1.720701045346718e+02 -1.721598097220100e+02 + -1.722495499971131e+02 -1.723393254438396e+02 -1.724291361494486e+02 -1.725189820532021e+02 -1.726088630837053e+02 + -1.726987792749333e+02 -1.727887306891670e+02 -1.728787173965418e+02 -1.729687394350333e+02 -1.730587967061244e+02 + -1.731488891286860e+02 -1.732390168276344e+02 -1.733291799265234e+02 -1.734193783374131e+02 -1.735096119603506e+02 + -1.735998808588243e+02 -1.736901851222248e+02 -1.737805247801124e+02 -1.738708998286339e+02 -1.739613101901119e+02 + -1.740517558114003e+02 -1.741422368113012e+02 -1.742327533050288e+02 -1.743233052214973e+02 -1.744138924793676e+02 + -1.745045151425876e+02 -1.745951732822802e+02 -1.746858668529805e+02 -1.747765958032038e+02 -1.748673601739718e+02 + -1.749581600245709e+02 -1.750489953948396e+02 -1.751398663036498e+02 -1.752307727054541e+02 -1.753217145616989e+02 + -1.754126919262226e+02 -1.755037048571098e+02 -1.755947533370347e+02 -1.756858373371216e+02 -1.757769568577038e+02 + -1.758681119173357e+02 -1.759593025782490e+02 -1.760505288876894e+02 -1.761417907892832e+02 -1.762330882344909e+02 + -1.763244213097290e+02 -1.764157900964081e+02 -1.765071945209611e+02 -1.765986345094344e+02 -1.766901101413071e+02 + -1.767816215026837e+02 -1.768731685527375e+02 -1.769647512369523e+02 -1.770563695729838e+02 -1.771480236027573e+02 + -1.772397133931058e+02 -1.773314389867134e+02 -1.774232003047593e+02 -1.775149972814722e+02 -1.776068300247813e+02 + -1.776986986385443e+02 -1.777906030366335e+02 -1.778825431235826e+02 -1.779745189565556e+02 -1.780665306226855e+02 + -1.781585781763529e+02 -1.782506616334199e+02 -1.783427808884287e+02 -1.784349358629673e+02 -1.785271267081259e+02 + -1.786193535668995e+02 -1.787116163204012e+02 -1.788039148425030e+02 -1.788962492399977e+02 -1.789886196318098e+02 + -1.790810259524725e+02 -1.791734681201561e+02 -1.792659461719689e+02 -1.793584601742520e+02 -1.794510101913400e+02 + -1.795435962594126e+02 -1.796362183040394e+02 -1.797288762617232e+02 -1.798215702233099e+02 -1.799143002757676e+02 + -1.800070663362093e+02 -1.800998683262517e+02 -1.801927063553792e+02 -1.802855805315161e+02 -1.803784907684791e+02 + -1.804714369692463e+02 -1.805644191875481e+02 -1.806574375103104e+02 -1.807504920064915e+02 -1.808435827084130e+02 + -1.809367095198169e+02 -1.810298723599504e+02 -1.811230713386593e+02 -1.812163065647390e+02 -1.813095779521854e+02 + -1.814028854036152e+02 -1.814962289709267e+02 -1.815896087407728e+02 -1.816830247895420e+02 -1.817764771515762e+02 + -1.818699657032943e+02 -1.819634903439186e+02 -1.820570512218083e+02 -1.821506484855823e+02 -1.822442820357622e+02 + -1.823379517614509e+02 -1.824316577541746e+02 -1.825254001134493e+02 -1.826191787683301e+02 -1.827129936397535e+02 + -1.828068447866412e+02 -1.829007322929544e+02 -1.829946562048259e+02 -1.830886165373395e+02 -1.831826132192083e+02 + -1.832766461922778e+02 -1.833707155372913e+02 -1.834648213380734e+02 -1.835589635518759e+02 -1.836531421229175e+02 + -1.837473570698571e+02 -1.838416084358642e+02 -1.839358962877114e+02 -1.840302206684350e+02 -1.841245815025237e+02 + -1.842189787235884e+02 -1.843134124202761e+02 -1.844078826806361e+02 -1.845023894352911e+02 -1.845969326205561e+02 + -1.846915123529413e+02 -1.847861287393624e+02 -1.848807816681596e+02 -1.849754710227848e+02 -1.850701968857076e+02 + -1.851649593688754e+02 -1.852597585031284e+02 -1.853545942804591e+02 -1.854494666185751e+02 -1.855443754618861e+02 + -1.856393209358935e+02 -1.857343031604275e+02 -1.858293220515437e+02 -1.859243775087027e+02 -1.860194695687597e+02 + -1.861145983033516e+02 -1.862097637858479e+02 -1.863049660540466e+02 -1.864002050017272e+02 -1.864954805431744e+02 + -1.865907928187129e+02 -1.866861419596013e+02 -1.867815278347963e+02 -1.868769503164351e+02 -1.869724095516791e+02 + -1.870679056966096e+02 -1.871634386679672e+02 -1.872590083560524e+02 -1.873546147847470e+02 -1.874502580123688e+02 + -1.875459381013990e+02 -1.876416550903780e+02 -1.877374089179168e+02 -1.878331995340542e+02 -1.879290270344656e+02 + -1.880248915055781e+02 -1.881207928511883e+02 -1.882167309755823e+02 -1.883127059676341e+02 -1.884087179360091e+02 + -1.885047668839511e+02 -1.886008527852007e+02 -1.886969756009047e+02 -1.887931353152428e+02 -1.888893320171184e+02 + -1.889855657829229e+02 -1.890818365342772e+02 -1.891781441947396e+02 -1.892744888503877e+02 -1.893708705921393e+02 + -1.894672893677523e+02 -1.895637451161106e+02 -1.896602378837592e+02 -1.897567677352667e+02 -1.898533346996371e+02 + -1.899499387807097e+02 -1.900465799172331e+02 -1.901432580674921e+02 -1.902399733330072e+02 -1.903367258125687e+02 + -1.904335154508099e+02 -1.905303421711713e+02 -1.906272059664800e+02 -1.907241068668330e+02 -1.908210449820209e+02 + -1.909180203947948e+02 -1.910150330000556e+02 -1.911120827002041e+02 -1.912091696154924e+02 -1.913062938635582e+02 + -1.914034553337337e+02 -1.915006539182285e+02 -1.915978897490666e+02 -1.916951629619544e+02 -1.917924734675151e+02 + -1.918898211586861e+02 -1.919872060827436e+02 -1.920846283161583e+02 -1.921820878978424e+02 -1.922795848438701e+02 + -1.923771191165239e+02 -1.924746906889474e+02 -1.925722996315181e+02 -1.926699460069926e+02 -1.927676297504074e+02 + -1.928653507913461e+02 -1.929631091652971e+02 -1.930609049367203e+02 -1.931587381800568e+02 -1.932566089358633e+02 + -1.933545170991796e+02 -1.934524625825225e+02 -1.935504455138344e+02 -1.936484660231147e+02 -1.937465240331655e+02 + -1.938446194535055e+02 -1.939427523477156e+02 -1.940409227930324e+02 -1.941391307672549e+02 -1.942373762317632e+02 + -1.943356591817002e+02 -1.944339796386271e+02 -1.945323376960147e+02 -1.946307334225392e+02 -1.947291667157886e+02 + -1.948276374816129e+02 -1.949261458299981e+02 -1.950246918758956e+02 -1.951232755499811e+02 -1.952218967672293e+02 + -1.953205555640852e+02 -1.954192520091347e+02 -1.955179861780584e+02 -1.956167581109271e+02 -1.957155676982765e+02 + -1.958144148511486e+02 -1.959132997121442e+02 -1.960122224157670e+02 -1.961111828325720e+02 -1.962101808324193e+02 + -1.963092165463342e+02 -1.964082901163006e+02 -1.965074014669716e+02 -1.966065505047830e+02 -1.967057372806285e+02 + -1.968049618689787e+02 -1.969042242941536e+02 -1.970035245570506e+02 -1.971028626150270e+02 -1.972022384428475e+02 + -1.973016521284466e+02 -1.974011037520065e+02 -1.975005932495305e+02 -1.976001205455443e+02 -1.976996856628438e+02 + -1.977992886519515e+02 -1.978989295760255e+02 -1.979986084767589e+02 -1.980983252973461e+02 -1.981980799861144e+02 + -1.982978726104215e+02 -1.983977032396124e+02 -1.984975718319531e+02 -1.985974783450467e+02 -1.986974228449224e+02 + -1.987974053983538e+02 -1.988974259666649e+02 -1.989974844962869e+02 -1.990975809795281e+02 -1.991977154414513e+02 + -1.992978879922588e+02 -1.993980987169082e+02 -1.994983475142392e+02 -1.995986342853965e+02 -1.996989591268633e+02 + -1.997993221398394e+02 -1.998997232490551e+02 -2.000001623829878e+02 -2.001006396615730e+02 -2.002011551976202e+02 + -2.003017088839768e+02 -2.004023006006677e+02 -2.005029303963877e+02 -2.006035983645368e+02 -2.007043046086661e+02 + -2.008050491826254e+02 -2.009058319313084e+02 -2.010066527248718e+02 -2.011075117434797e+02 -2.012084091672780e+02 + -2.013093448663347e+02 -2.014103186854462e+02 -2.015113306783989e+02 -2.016123809487723e+02 -2.017134695903300e+02 + -2.018145966520298e+02 -2.019157620134241e+02 -2.020169655668574e+02 -2.021182074252480e+02 -2.022194877090834e+02 + -2.023208063485549e+02 -2.024221632682046e+02 -2.025235585602719e+02 -2.026249923196053e+02 -2.027264644837921e+02 + -2.028279749730532e+02 -2.029295237954015e+02 -2.030311109992572e+02 -2.031327367068774e+02 -2.032344010007734e+02 + -2.033361037306376e+02 -2.034378447601810e+02 -2.035396242420057e+02 -2.036414423389593e+02 -2.037432989659801e+02 + -2.038451940079258e+02 -2.039471274772405e+02 -2.040490994323931e+02 -2.041511099883670e+02 -2.042531592234435e+02 + -2.043552470125819e+02 -2.044573732391661e+02 -2.045595380236004e+02 -2.046617414909655e+02 -2.047639835480296e+02 + -2.048662640993485e+02 -2.049685832589404e+02 -2.050709411450770e+02 -2.051733376835843e+02 -2.052757727854042e+02 + -2.053782464943871e+02 -2.054807588829732e+02 -2.055833100050551e+02 -2.056858998827895e+02 -2.057885284299405e+02 + -2.058911955783421e+02 -2.059939014405005e+02 -2.060966461276917e+02 -2.061994295656012e+02 -2.063022516666823e+02 + -2.064051124760526e+02 -2.065080120661920e+02 -2.066109504863692e+02 -2.067139277576765e+02 -2.068169438117121e+02 + -2.069199985973326e+02 -2.070230922219201e+02 -2.071262247789163e+02 -2.072293961474789e+02 -2.073326062201854e+02 + -2.074358551575783e+02 -2.075391431180403e+02 -2.076424699833530e+02 -2.077458356179337e+02 -2.078492400933438e+02 + -2.079526835133251e+02 -2.080561659031989e+02 -2.081596872578975e+02 -2.082632475292167e+02 -2.083668466898186e+02 + -2.084704848389632e+02 -2.085741620623951e+02 -2.086778782651976e+02 -2.087816333480700e+02 -2.088854273748348e+02 + -2.089892604383302e+02 -2.090931325843364e+02 -2.091970438282278e+02 -2.093009941108145e+02 -2.094049833841979e+02 + -2.095090117202067e+02 -2.096130791905716e+02 -2.097171857469022e+02 -2.098213313423286e+02 -2.099255160561849e+02 + -2.100297399619016e+02 -2.101340029830976e+02 -2.102383050403986e+02 -2.103426461922712e+02 -2.104470265253758e+02 + -2.105514461013085e+02 -2.106559049410852e+02 -2.107604029284658e+02 -2.108649399745926e+02 -2.109695162373935e+02 + -2.110741318706494e+02 -2.111787867647689e+02 -2.112834807867834e+02 -2.113882139735869e+02 -2.114929864074473e+02 + -2.115977981822681e+02 -2.117026493533424e+02 -2.118075398098887e+02 -2.119124694556393e+02 -2.120174384184601e+02 + -2.121224468216736e+02 -2.122274945462991e+02 -2.123325814769304e+02 -2.124377077547605e+02 -2.125428735238108e+02 + -2.126480786828185e+02 -2.127533231155498e+02 -2.128586068911697e+02 -2.129639301084739e+02 -2.130692927993837e+02 + -2.131746949622090e+02 -2.132801365276879e+02 -2.133856174488912e+02 -2.134911378357916e+02 -2.135966977951921e+02 + -2.137022972643151e+02 -2.138079361581469e+02 -2.139136144723085e+02 -2.140193322420075e+02 -2.141250895801643e+02 + -2.142308865713384e+02 -2.143367231089345e+02 -2.144425990899214e+02 -2.145485146166798e+02 -2.146544697958461e+02 + -2.147604645456698e+02 -2.148664987887291e+02 -2.149725726533044e+02 -2.150786862586875e+02 -2.151848394825147e+02 + -2.152910321964648e+02 -2.153972644900385e+02 -2.155035364828845e+02 -2.156098481974242e+02 -2.157161996246267e+02 + -2.158225907268823e+02 -2.159290214790141e+02 -2.160354919341570e+02 -2.161420021424622e+02 -2.162485520638355e+02 + -2.163551416576007e+02 -2.164617709709994e+02 -2.165684400663080e+02 -2.166751489780245e+02 -2.167818977145845e+02 + -2.168886862079515e+02 -2.169955144082682e+02 -2.171023824148656e+02 -2.172092903208214e+02 -2.173162380450137e+02 + -2.174232255130703e+02 -2.175302528518165e+02 -2.176373201799158e+02 -2.177444273821862e+02 -2.178515743317612e+02 + -2.179587610888773e+02 -2.180659877532527e+02 -2.181732543954297e+02 -2.182805610486399e+02 -2.183879076260487e+02 + -2.184952940541088e+02 -2.186027204324891e+02 -2.187101868605661e+02 -2.188176932633304e+02 -2.189252395535715e+02 + -2.190328257696591e+02 -2.191404519835346e+02 -2.192481182758485e+02 -2.193558246894080e+02 -2.194635711069396e+02 + -2.195713574321837e+02 -2.196791838130171e+02 -2.197870503917547e+02 -2.198949570443306e+02 -2.200029036478261e+02 + -2.201108903502962e+02 -2.202189173008489e+02 -2.203269843818326e+02 -2.204350914576510e+02 -2.205432385876858e+02 + -2.206514258738742e+02 -2.207596533933995e+02 -2.208679211808499e+02 -2.209762291251867e+02 -2.210845771334710e+02 + -2.211929653307878e+02 -2.213013938407175e+02 -2.214098625627986e+02 -2.215183713969045e+02 -2.216269204682873e+02 + -2.217355099024502e+02 -2.218441396005216e+02 -2.219528094497077e+02 -2.220615195058979e+02 -2.221702698646027e+02 + -2.222790606111339e+02 -2.223878917838657e+02 -2.224967632436199e+02 -2.226056748766821e+02 -2.227146268487432e+02 + -2.228236193240230e+02 -2.229326521814535e+02 -2.230417252803019e+02 -2.231508386864637e+02 -2.232599925050409e+02 + -2.233691867913336e+02 -2.234784215614204e+02 -2.235876967242961e+02 -2.236970122086523e+02 -2.238063681290529e+02 + -2.239157646015454e+02 -2.240252015622403e+02 -2.241346789340316e+02 -2.242441967668838e+02 -2.243537551247286e+02 + -2.244633540002964e+02 -2.245729933685804e+02 -2.246826732048266e+02 -2.247923935126906e+02 -2.249021544092157e+02 + -2.250119559889259e+02 -2.251217981428817e+02 -2.252316807628839e+02 -2.253416039471573e+02 -2.254515678046834e+02 + -2.255615722810486e+02 -2.256716173029860e+02 -2.257817028852108e+02 -2.258918290784169e+02 -2.260019959892315e+02 + -2.261122036854213e+02 -2.262224520233766e+02 -2.263327408802082e+02 -2.264430704272837e+02 -2.265534408332552e+02 + -2.266638519616550e+02 -2.267743036660735e+02 -2.268847960654481e+02 -2.269953292962885e+02 -2.271059033000460e+02 + -2.272165179952407e+02 -2.273271734037251e+02 -2.274378695801794e+02 -2.275486066072624e+02 -2.276593845334010e+02 + -2.277702032421150e+02 -2.278810626343348e+02 -2.279919628455381e+02 -2.281029040172474e+02 -2.282138860806176e+02 + -2.283249089376286e+02 -2.284359725839265e+02 -2.285470770593814e+02 -2.286582224870930e+02 -2.287694089544078e+02 + -2.288806363224278e+02 -2.289919044640359e+02 -2.291032135254801e+02 -2.292145636582007e+02 -2.293259547610424e+02 + -2.294373867252146e+02 -2.295488596639802e+02 -2.296603736910369e+02 -2.297719286997702e+02 -2.298835245768747e+02 + -2.299951614025932e+02 -2.301068392919157e+02 -2.302185583052736e+02 -2.303303184582155e+02 -2.304421196413199e+02 + -2.305539617649887e+02 -2.306658449438852e+02 -2.307777692999738e+02 -2.308897347801602e+02 -2.310017413072381e+02 + -2.311137888826106e+02 -2.312258775426401e+02 -2.313380073849178e+02 -2.314501784790464e+02 -2.315623907214496e+02 + -2.316746440227619e+02 -2.317869385236417e+02 -2.318992743527083e+02 -2.320116513604021e+02 -2.321240694060221e+02 + -2.322365286624793e+02 -2.323490293043759e+02 -2.324615711994689e+02 -2.325741541998047e+02 -2.326867784014305e+02 + -2.327994439322068e+02 -2.329121508032486e+02 -2.330248989898164e+02 -2.331376884404961e+02 -2.332505191272475e+02 + -2.333633911421986e+02 -2.334763045743060e+02 -2.335892593796759e+02 -2.337022554911374e+02 -2.338152928812627e+02 + -2.339283715644559e+02 -2.340414916827054e+02 -2.341546533474617e+02 -2.342678564204413e+02 -2.343811007676228e+02 + -2.344943865217682e+02 -2.346077138212040e+02 -2.347210825597340e+02 -2.348344926295532e+02 -2.349479441609453e+02 + -2.350614372851493e+02 -2.351749718991416e+02 -2.352885478850955e+02 -2.354021653002366e+02 -2.355158242429473e+02 + -2.356295248011875e+02 -2.357432670145577e+02 -2.358570507396431e+02 -2.359708758587992e+02 -2.360847425404777e+02 + -2.361986509531367e+02 -2.363126009791645e+02 -2.364265924750662e+02 -2.365406254798825e+02 -2.366547000814751e+02 + -2.367688163804559e+02 -2.368829744348273e+02 -2.369971741194025e+02 -2.371114153287764e+02 -2.372256982198593e+02 + -2.373400229428812e+02 -2.374543893590377e+02 -2.375687973238754e+02 -2.376832469593778e+02 -2.377977384043928e+02 + -2.379122715987879e+02 -2.380268464580362e+02 -2.381414629990116e+02 -2.382561212769444e+02 -2.383708213990897e+02 + -2.384855634334210e+02 -2.386003472387607e+02 -2.387151726904082e+02 -2.388300399387221e+02 -2.389449491374237e+02 + -2.390599001786255e+02 -2.391748929369255e+02 -2.392899274784697e+02 -2.394050039061344e+02 -2.395201222781684e+02 + -2.396352826134916e+02 -2.397504848183333e+02 -2.398657288168898e+02 -2.399810147179146e+02 -2.400963426277219e+02 + -2.402117124583125e+02 -2.403271241258893e+02 -2.404425777577767e+02 -2.405580734795174e+02 -2.406736111984077e+02 + -2.407891907995794e+02 -2.409048122977546e+02 -2.410204757554728e+02 -2.411361812969551e+02 -2.412519290053517e+02 + -2.413677187378485e+02 -2.414835503650167e+02 -2.415994240369316e+02 -2.417153399089511e+02 -2.418312978780588e+02 + -2.419472978191357e+02 -2.420633397770240e+02 -2.421794238369657e+02 -2.422955500758429e+02 -2.424117185344053e+02 + -2.425279291172331e+02 -2.426441817421263e+02 -2.427604765159341e+02 -2.428768135466203e+02 -2.429931927575585e+02 + -2.431096140668555e+02 -2.432260775561414e+02 -2.433425833145866e+02 -2.434591312980004e+02 -2.435757214497087e+02 + -2.436923537964655e+02 -2.438090283895336e+02 -2.439257452947832e+02 -2.440425045463603e+02 -2.441593060369063e+02 + -2.442761496825792e+02 -2.443930356351059e+02 -2.445099640393889e+02 -2.446269347774639e+02 -2.447439477225602e+02 + -2.448610029755453e+02 -2.449781006544274e+02 -2.450952407181387e+02 -2.452124231032676e+02 -2.453296478161015e+02 + -2.454469148921256e+02 -2.455642244139170e+02 -2.456815764363974e+02 -2.457989708567751e+02 -2.459164075868465e+02 + -2.460338867544718e+02 -2.461514084874868e+02 -2.462689726975661e+02 -2.463865792818051e+02 -2.465042282951439e+02 + -2.466219198202147e+02 -2.467396538925739e+02 -2.468574305187124e+02 -2.469752496359336e+02 -2.470931112029433e+02 + -2.472110153332446e+02 -2.473289621270786e+02 -2.474469514768406e+02 -2.475649832814832e+02 -2.476830576740329e+02 + -2.478011747871381e+02 -2.479193345178656e+02 -2.480375367456449e+02 -2.481557815149384e+02 -2.482740689103307e+02 + -2.483923990118631e+02 -2.485107718618152e+02 -2.486291873559622e+02 -2.487476454083695e+02 -2.488661461527674e+02 + -2.489846897184250e+02 -2.491032759971039e+02 -2.492219048675295e+02 -2.493405763937896e+02 -2.494592906781626e+02 + -2.495780477903268e+02 -2.496968477531592e+02 -2.498156904349301e+02 -2.499345757349562e+02 -2.500535038313474e+02 + -2.501724748933778e+02 -2.502914887761886e+02 -2.504105453266259e+02 -2.505296446724864e+02 -2.506487869586733e+02 + -2.507679721175656e+02 -2.508872000588222e+02 -2.510064708137437e+02 -2.511257844438344e+02 -2.512451410097723e+02 + -2.513645405425343e+02 -2.514839829551193e+02 -2.516034681806881e+02 -2.517229963510282e+02 -2.518425675906852e+02 + -2.519621817966139e+02 -2.520818388494823e+02 -2.522015387924022e+02 -2.523212817096907e+02 -2.524410676880414e+02 + -2.525608967718439e+02 -2.526807688338955e+02 -2.528006837687293e+02 -2.529206417294141e+02 -2.530406428681973e+02 + -2.531606870755077e+02 -2.532807742357317e+02 -2.534009044709059e+02 -2.535210779031462e+02 -2.536412944172385e+02 + -2.537615538911017e+02 -2.538818564125164e+02 -2.540022021028112e+02 -2.541225910076441e+02 -2.542430231270507e+02 + -2.543634983542462e+02 -2.544840166121418e+02 -2.546045780492533e+02 -2.547251828099108e+02 -2.548458307960956e+02 + -2.549665218842466e+02 -2.550872560909815e+02 -2.552080334828205e+02 -2.553288541857174e+02 -2.554497182835964e+02 + -2.555706256328296e+02 -2.556915761009198e+02 -2.558125698274442e+02 -2.559336069560756e+02 -2.560546873747970e+02 + -2.561758109689862e+02 -2.562969778692906e+02 -2.564181882127723e+02 -2.565394419168841e+02 -2.566607388759341e+02 + -2.567820791112567e+02 -2.569034626862424e+02 -2.570248897054782e+02 -2.571463602359873e+02 -2.572678741533426e+02 + -2.573894313462550e+02 -2.575110319474426e+02 -2.576326760938784e+02 -2.577543636955484e+02 -2.578760946446893e+02 + -2.579978689895271e+02 -2.581196868133063e+02 -2.582415481833543e+02 -2.583634531275302e+02 -2.584854015317316e+02 + -2.586073933093156e+02 -2.587294286254374e+02 -2.588515076317444e+02 -2.589736301740566e+02 -2.590957960996737e+02 + -2.592180055676404e+02 -2.593402587446819e+02 -2.594625555165019e+02 -2.595848957490105e+02 -2.597072795099639e+02 + -2.598297069067293e+02 -2.599521780032740e+02 -2.600746928207452e+02 -2.601972512524080e+02 -2.603198532148209e+02 + -2.604424988455961e+02 -2.605651882765137e+02 -2.606879213949725e+02 -2.608106980758151e+02 -2.609335183880386e+02 + -2.610563824372016e+02 -2.611792902809524e+02 -2.613022419394243e+02 -2.614252373306019e+02 -2.615482763897488e+02 + -2.616713592233935e+02 -2.617944859260970e+02 -2.619176563732862e+02 -2.620408704583867e+02 -2.621641283659552e+02 + -2.622874302706103e+02 -2.624107760160917e+02 -2.625341654302978e+02 -2.626575986086381e+02 -2.627810756876698e+02 + -2.629045967010318e+02 -2.630281616427657e+02 -2.631517704514422e+02 -2.632754230861743e+02 -2.633991196437133e+02 + -2.635228602105341e+02 -2.636466446943674e+02 -2.637704729984163e+02 -2.638943451865159e+02 -2.640182613561179e+02 + -2.641422215785110e+02 -2.642662258795402e+02 -2.643902741294400e+02 -2.645143662245587e+02 -2.646385023213122e+02 + -2.647626825745115e+02 -2.648869068724856e+02 -2.650111750962730e+02 -2.651354873642347e+02 -2.652598438005879e+02 + -2.653842443156531e+02 -2.655086888035231e+02 -2.656331773072787e+02 -2.657577099091213e+02 -2.658822866987512e+02 + -2.660069077230897e+02 -2.661315728504449e+02 -2.662562819710931e+02 -2.663810352417937e+02 -2.665058328192844e+02 + -2.666306745937331e+02 -2.667555604333347e+02 -2.668804903849584e+02 -2.670054645383429e+02 -2.671304829760297e+02 + -2.672555457413816e+02 -2.673806527282453e+02 -2.675058038464400e+02 -2.676309992191929e+02 -2.677562389652032e+02 + -2.678815229716541e+02 -2.680068511277727e+02 -2.681322235624782e+02 -2.682576404136338e+02 -2.683831016151858e+02 + -2.685086070756685e+02 -2.686341568058856e+02 -2.687597508516357e+02 -2.688853892964312e+02 -2.690110721950252e+02 + -2.691367994494158e+02 -2.692625709807897e+02 -2.693883869398372e+02 -2.695142474621058e+02 -2.696401523930688e+02 + -2.697661015819900e+02 -2.698920951833660e+02 -2.700181333642693e+02 -2.701442160368443e+02 -2.702703430840482e+02 + -2.703965145270174e+02 -2.705227304331903e+02 -2.706489909170355e+02 -2.707752960482972e+02 -2.709016456707917e+02 + -2.710280396495872e+02 -2.711544781606855e+02 -2.712809613853167e+02 -2.714074892146895e+02 -2.715340615102555e+02 + -2.716606783044584e+02 -2.717873396730564e+02 -2.719140456940721e+02 -2.720407964136753e+02 -2.721675917483545e+02 + -2.722944316245073e+02 -2.724213161378437e+02 -2.725482453844213e+02 -2.726752192923742e+02 -2.728022377909456e+02 + -2.729293009817382e+02 -2.730564089616648e+02 -2.731835616365174e+02 -2.733107589046467e+02 -2.734380008257563e+02 + -2.735652874983575e+02 -2.736926190148396e+02 -2.738199954194386e+02 -2.739474165698984e+02 -2.740748823405867e+02 + -2.742023928588563e+02 -2.743299482670098e+02 -2.744575485141638e+02 -2.745851935229188e+02 -2.747128833029967e+02 + -2.748406178969678e+02 -2.749683973916734e+02 -2.750962218440648e+02 -2.752240911472609e+02 -2.753520052060601e+02 + -2.754799641358123e+02 -2.756079680559450e+02 -2.757360168916492e+02 -2.758641105650285e+02 -2.759922491800748e+02 + -2.761204328366440e+02 -2.762486614361617e+02 -2.763769348745897e+02 -2.765052532244616e+02 -2.766336165883748e+02 + -2.767620250126050e+02 -2.768904785041199e+02 -2.770189769689730e+02 -2.771475203398639e+02 -2.772761087569904e+02 + -2.774047423518460e+02 -2.775334210136085e+02 -2.776621446145333e+02 -2.777909132015001e+02 -2.779197268642361e+02 + -2.780485856892346e+02 -2.781774897218528e+02 -2.783064388461343e+02 -2.784354329669438e+02 -2.785644722337429e+02 + -2.786935567875348e+02 -2.788226864908934e+02 -2.789518612068105e+02 -2.790810810783757e+02 -2.792103462555617e+02 + -2.793396566357773e+02 -2.794690121008859e+02 -2.795984127231330e+02 -2.797278586088501e+02 -2.798573498103315e+02 + -2.799868863353985e+02 -2.801164680680156e+02 -2.802460949220819e+02 -2.803757670550874e+02 -2.805054846206144e+02 + -2.806352475130235e+02 -2.807650555997772e+02 -2.808949088999684e+02 -2.810248074853591e+02 -2.811547514867556e+02 + -2.812847409903677e+02 -2.814147758449749e+02 -2.815448559108459e+02 -2.816749813316353e+02 -2.818051522586102e+02 + -2.819353685901064e+02 -2.820656302199222e+02 -2.821959372766401e+02 -2.823262898869716e+02 -2.824566879353637e+02 + -2.825871312931868e+02 -2.827176200217700e+02 -2.828481542276227e+02 -2.829787340080183e+02 -2.831093594072626e+02 + -2.832400302670260e+02 -2.833707464559445e+02 -2.835015081531469e+02 -2.836323155420096e+02 -2.837631685124079e+02 + -2.838940669226656e+02 -2.840250107984012e+02 -2.841560002155769e+02 -2.842870352842360e+02 -2.844181160721325e+02 + -2.845492424437817e+02 -2.846804142799303e+02 -2.848116317294889e+02 -2.849428949404899e+02 -2.850742037892878e+02 + -2.852055581519247e+02 -2.853369581748677e+02 -2.854684040068092e+02 -2.855998955349205e+02 -2.857314326251873e+02 + -2.858630153203723e+02 -2.859946437114748e+02 -2.861263179056654e+02 -2.862580379663874e+02 -2.863898037660037e+02 + -2.865216151879669e+02 -2.866534723511688e+02 -2.867853753832939e+02 -2.869173242117615e+02 -2.870493187426322e+02 + -2.871813589967982e+02 -2.873134450373917e+02 -2.874455769816758e+02 -2.875777549027032e+02 -2.877099786425546e+02 + -2.878422480619707e+02 -2.879745633273037e+02 -2.881069246090204e+02 -2.882393317884377e+02 -2.883717847366556e+02 + -2.885042835730584e+02 -2.886368284288774e+02 -2.887694192344474e+02 -2.889020558953364e+02 -2.890347384189399e+02 + -2.891674668528066e+02 -2.893002413032724e+02 -2.894330618447220e+02 -2.895659283649483e+02 -2.896988407604515e+02 + -2.898317991491523e+02 -2.899648036558058e+02 -2.900978542110840e+02 -2.902309507220182e+02 -2.903640931951591e+02 + -2.904972816775983e+02 -2.906305162790740e+02 -2.907637970750559e+02 -2.908971239412933e+02 -2.910304967707643e+02 + -2.911639157250792e+02 -2.912973809535366e+02 -2.914308922875549e+02 -2.915644495654761e+02 -2.916980529712119e+02 + -2.918317026983915e+02 -2.919653986339440e+02 -2.920991406314096e+02 -2.922329287174719e+02 -2.923667629702973e+02 + -2.925006435008390e+02 -2.926345703772706e+02 -2.927685434638595e+02 -2.929025626397000e+02 -2.930366280470975e+02 + -2.931707398343328e+02 -2.933048979103752e+02 -2.934391021578708e+02 -2.935733525934834e+02 -2.937076492857184e+02 + -2.938419923764308e+02 -2.939763819565550e+02 -2.941108178399977e+02 -2.942452998623305e+02 -2.943798282228154e+02 + -2.945144031200941e+02 -2.946490243866398e+02 -2.947836918481424e+02 -2.949184056693277e+02 -2.950531660302706e+02 + -2.951879728334102e+02 -2.953228259514730e+02 -2.954577254159683e+02 -2.955926713017622e+02 -2.957276636983648e+02 + -2.958627026572042e+02 -2.959977880627373e+02 -2.961329198152110e+02 -2.962680980450039e+02 -2.964033228802077e+02 + -2.965385942096344e+02 -2.966739119278574e+02 -2.968092761917713e+02 -2.969446871501122e+02 -2.970801446566606e+02 + -2.972156485544735e+02 -2.973511989386669e+02 -2.974867959450954e+02 -2.976224396205114e+02 -2.977581299655766e+02 + -2.978938668856917e+02 -2.980296503111913e+02 -2.981654803674056e+02 -2.983013571739824e+02 -2.984372806328453e+02 + -2.985732506311156e+02 -2.987092672144286e+02 -2.988453304703744e+02 -2.989814404958496e+02 -2.991175973412398e+02 + -2.992538008615809e+02 -2.993900509369414e+02 -2.995263477428711e+02 -2.996626914493826e+02 -2.997990819088619e+02 + -2.999355189707111e+02 -3.000720027900217e+02 -3.002085335269560e+02 -3.003451110562723e+02 -3.004817352353309e+02 + -3.006184061373012e+02 -3.007551238767678e+02 -3.008918885181671e+02 -3.010287000846923e+02 -3.011655584847104e+02 + -3.013024636430795e+02 -3.014394156654455e+02 -3.015764146559894e+02 -3.017134605322491e+02 -3.018505532010304e+02 + -3.019876927128527e+02 -3.021248791518991e+02 -3.022621125932933e+02 -3.023993930706231e+02 -3.025367204603900e+02 + -3.026740946641424e+02 -3.028115158406990e+02 -3.029489841386069e+02 -3.030864994080570e+02 -3.032240615026816e+02 + -3.033616705882347e+02 -3.034993268395738e+02 -3.036370301558538e+02 -3.037747804087723e+02 -3.039125776359002e+02 + -3.040504219146317e+02 -3.041883133157825e+02 -3.043262518737324e+02 -3.044642374836954e+02 -3.046022700638564e+02 + -3.047403497634464e+02 -3.048784767248004e+02 -3.050166508316213e+02 -3.051548719471290e+02 -3.052931401112401e+02 + -3.054314554166776e+02 -3.055698179906950e+02 -3.057082279030724e+02 -3.058466849591645e+02 -3.059851889955948e+02 + -3.061237402384871e+02 -3.062623389075358e+02 -3.064009848072192e+02 -3.065396777363650e+02 -3.066784178864098e+02 + -3.068172054654241e+02 -3.069560403554044e+02 -3.070949224023651e+02 -3.072338516344630e+02 -3.073728281334552e+02 + -3.075118520133569e+02 -3.076509233435525e+02 -3.077900419826468e+02 -3.079292078053290e+02 -3.080684209614084e+02 + -3.082076816048298e+02 -3.083469896309615e+02 -3.084863449149456e+02 -3.086257475095906e+02 -3.087651975081579e+02 + -3.089046949880547e+02 -3.090442399817611e+02 -3.091838323579038e+02 -3.093234720151574e+02 -3.094631591362355e+02 + -3.096028938900603e+02 -3.097426761063483e+02 -3.098825056148365e+02 -3.100223825845469e+02 -3.101623071983122e+02 + -3.103022793549238e+02 -3.104422989228102e+02 -3.105823659329897e+02 -3.107224804626276e+02 -3.108626426108901e+02 + -3.110028524323948e+02 -3.111431097815640e+02 -3.112834145351391e+02 -3.114237668593314e+02 -3.115641669247677e+02 + -3.117046146302696e+02 -3.118451098470761e+02 -3.119856526079039e+02 -3.121262429897644e+02 -3.122668810853719e+02 + -3.124075669478935e+02 -3.125483004566077e+02 -3.126890815070839e+02 -3.128299102339429e+02 -3.129707867704560e+02 + -3.131117110054437e+02 -3.132526828292356e+02 -3.133937023826453e+02 -3.135347698019019e+02 -3.136758849544115e+02 + -3.138170476993112e+02 -3.139582581314797e+02 -3.140995163841689e+02 -3.142408225083815e+02 -3.143821765079714e+02 + -3.145235782804463e+02 -3.146650277504123e+02 -3.148065250572144e+02 -3.149480703283944e+02 -3.150896634295446e+02 + -3.152313042212708e+02 -3.153729928061792e+02 -3.155147293192109e+02 -3.156565137826469e+02 -3.157983461803634e+02 + -3.159402264552761e+02 -3.160821545730877e+02 -3.162241306316100e+02 -3.163661547129774e+02 -3.165082267045055e+02 + -3.166503465083330e+02 -3.167925142807053e+02 -3.169347301718565e+02 -3.170769940538677e+02 -3.172193057829434e+02 + -3.173616654299331e+02 -3.175040731106142e+02 -3.176465289058318e+02 -3.177890328440690e+02 -3.179315847792938e+02 + -3.180741845934695e+02 -3.182168324550577e+02 -3.183595285351408e+02 -3.185022727287870e+02 -3.186450649049847e+02 + -3.187879051044167e+02 -3.189307934072479e+02 -3.190737298798787e+02 -3.192167145562098e+02 -3.193597473539087e+02 + -3.195028282067584e+02 -3.196459572292360e+02 -3.197891345287240e+02 -3.199323600035334e+02 -3.200756335516368e+02 + -3.202189552787263e+02 -3.203623252990410e+02 -3.205057435532916e+02 -3.206492099607363e+02 -3.207927245283494e+02 + -3.209362873029775e+02 -3.210798984032395e+02 -3.212235579095965e+02 -3.213672656781062e+02 -3.215110215776564e+02 + -3.216548257528610e+02 -3.217986783602123e+02 -3.219425793279964e+02 -3.220865285490494e+02 -3.222305260026159e+02 + -3.223745717228416e+02 -3.225186658770672e+02 -3.226628085862362e+02 -3.228069996525048e+02 -3.229512388959131e+02 + -3.230955265268207e+02 -3.232398627556209e+02 -3.233842474025269e+02 -3.235286802821290e+02 -3.236731615767077e+02 + -3.238176914785998e+02 -3.239622698526831e+02 -3.241068965416273e+02 -3.242515716267282e+02 -3.243962952303619e+02 + -3.245410674006047e+02 -3.246858881442026e+02 -3.248307573768830e+02 -3.249756750377737e+02 -3.251206412506237e+02 + -3.252656561247559e+02 -3.254107195271718e+02 -3.255558313340717e+02 -3.257009917007768e+02 -3.258462007853361e+02 + -3.259914584775946e+02 -3.261367646471811e+02 -3.262821193510638e+02 -3.264275226864755e+02 -3.265729747243638e+02 + -3.267184754961565e+02 -3.268640249014856e+02 -3.270096228564299e+02 -3.271552694746495e+02 -3.273009648690628e+02 + -3.274467089520415e+02 -3.275925016223748e+02 -3.277383429250694e+02 -3.278842329472037e+02 -3.280301717979274e+02 + -3.281761595333842e+02 -3.283221959756238e+02 -3.284682809773962e+02 -3.286144147483458e+02 -3.287605974914733e+02 + -3.289068290263132e+02 -3.290531091681708e+02 -3.291994380988984e+02 -3.293458160115122e+02 -3.294922427771376e+02 + -3.296387182388717e+02 -3.297852424495862e+02 -3.299318155124273e+02 -3.300784375218649e+02 -3.302251085265343e+02 + -3.303718284004092e+02 -3.305185970357408e+02 -3.306654145725511e+02 -3.308122811494171e+02 -3.309591966513669e+02 + -3.311061609508276e+02 -3.312531741233722e+02 -3.314002362831168e+02 -3.315473474952068e+02 -3.316945077733321e+02 + -3.318417169743284e+02 -3.319889749946440e+02 -3.321362820460264e+02 -3.322836383216903e+02 -3.324310436254205e+02 + -3.325784977579187e+02 -3.327260008969810e+02 -3.328735532388732e+02 -3.330211546766479e+02 -3.331688050699581e+02 + -3.333165044480712e+02 -3.334642528918999e+02 -3.336120505193238e+02 -3.337598974031960e+02 -3.339077933992973e+02 + -3.340557383761620e+02 -3.342037324704123e+02 -3.343517758263186e+02 -3.344998683506588e+02 -3.346480099317598e+02 + -3.347962006216366e+02 -3.349444405123485e+02 -3.350927296924430e+02 -3.352410681997821e+02 -3.353894558729969e+02 + -3.355378925848257e+02 -3.356863785436656e+02 -3.358349139484366e+02 -3.359834986244929e+02 -3.361321323883865e+02 + -3.362808153950241e+02 -3.364295478191028e+02 -3.365783295761255e+02 -3.367271605486342e+02 -3.368760407465185e+02 + -3.370249702279324e+02 -3.371739491167402e+02 -3.373229774932894e+02 -3.374720551981496e+02 -3.376211820935624e+02 + -3.377703583682330e+02 -3.379195842066430e+02 -3.380688594499171e+02 -3.382181839217990e+02 -3.383675577198622e+02 + -3.385169809890102e+02 -3.386664537896355e+02 -3.388159761271593e+02 -3.389655478716282e+02 -3.391151689236262e+02 + -3.392648394412631e+02 -3.394145595795439e+02 -3.395643292235305e+02 -3.397141482525620e+02 -3.398640167930273e+02 + -3.400139349724158e+02 -3.401639026755699e+02 -3.403139197760493e+02 -3.404639863449279e+02 -3.406141024957107e+02 + -3.407642683141136e+02 -3.409144838324194e+02 -3.410647488969659e+02 -3.412150633828331e+02 -3.413654274660125e+02 + -3.415158413252182e+02 -3.416663048491409e+02 -3.418168178992377e+02 -3.419673805180489e+02 -3.421179927901010e+02 + -3.422686547867838e+02 -3.424193665441726e+02 -3.425701279702224e+02 -3.427209389917095e+02 -3.428717997388184e+02 + -3.430227103286458e+02 -3.431736706225328e+02 -3.433246804902436e+02 -3.434757400909901e+02 -3.436268495884827e+02 + -3.437780088749811e+02 -3.439292178162220e+02 -3.440804764432992e+02 -3.442317848369893e+02 -3.443831431114438e+02 + -3.445345513395477e+02 -3.446860093957458e+02 -3.448375171638715e+02 -3.449890747637513e+02 -3.451406823209921e+02 + -3.452923397483303e+02 -3.454440469383874e+02 -3.455958039161959e+02 -3.457476107544265e+02 -3.458994675838882e+02 + -3.460513744837874e+02 -3.462033312687789e+02 -3.463553377809081e+02 -3.465073942363314e+02 -3.466595008454457e+02 + -3.468116574214998e+02 -3.469638637732855e+02 -3.471161200889126e+02 -3.472684265676839e+02 -3.474207830743587e+02 + -3.475731894457752e+02 -3.477256457416318e+02 -3.478781520698926e+02 -3.480307085087305e+02 -3.481833150905516e+02 + -3.483359716944890e+02 -3.484886782275422e+02 -3.486414348614480e+02 -3.487942417546251e+02 -3.489470987474849e+02 + -3.491000056682386e+02 -3.492529626143035e+02 -3.494059697303613e+02 -3.495590270809477e+02 -3.497121346735108e+02 + -3.498652923672977e+02 -3.500185000578142e+02 -3.501717579338015e+02 -3.503250661735650e+02 -3.504784246204307e+02 + -3.506318331106053e+02 -3.507852917867942e+02 -3.509388008057230e+02 -3.510923600737020e+02 -3.512459694729739e+02 + -3.513996290399252e+02 -3.515533388531561e+02 -3.517070990059733e+02 -3.518609095547224e+02 -3.520147703931951e+02 + -3.521686814254426e+02 -3.523226427591028e+02 -3.524766545004363e+02 -3.526307165466042e+02 -3.527848288024159e+02 + -3.529389914123712e+02 -3.530932045168612e+02 -3.532474680001527e+02 -3.534017817301934e+02 -3.535561457657783e+02 + -3.537105602073667e+02 -3.538650251312291e+02 -3.540195405716707e+02 -3.541741064193253e+02 -3.543287225825957e+02 + -3.544833891846346e+02 -3.546381063473606e+02 -3.547928739730113e+02 -3.549476919508821e+02 -3.551025603381796e+02 + -3.552574792297605e+02 -3.554124487031720e+02 -3.555674687945711e+02 -3.557225393918643e+02 -3.558776604020463e+02 + -3.560328319567154e+02 -3.561880541805177e+02 -3.563433269456882e+02 -3.564986501330765e+02 -3.566540239103983e+02 + -3.568094484429710e+02 -3.569649235996524e+02 -3.571204492251743e+02 -3.572760253642205e+02 -3.574316521198430e+02 + -3.575873296286128e+02 -3.577430579645793e+02 -3.578988369181832e+02 -3.580546663122107e+02 -3.582105463824335e+02 + -3.583664773634632e+02 -3.585224590722860e+02 -3.586784912980774e+02 -3.588345741363943e+02 -3.589907077420278e+02 + -3.591468922003262e+02 -3.593031275347307e+02 -3.594594135904955e+02 -3.596157502414973e+02 -3.597721376542854e+02 + -3.599285759961583e+02 -3.600850651447366e+02 -3.602416049709182e+02 -3.603981956083848e+02 -3.605548371920680e+02 + -3.607115295991184e+02 -3.608682726958015e+02 -3.610250665626241e+02 -3.611819113190277e+02 -3.613388070259530e+02 + -3.614957536972620e+02 -3.616527512170044e+02 -3.618097994957786e+02 -3.619668986801910e+02 -3.621240489112448e+02 + -3.622812500715253e+02 -3.624385020268735e+02 -3.625958048345691e+02 -3.627531585959862e+02 -3.629105633974360e+02 + -3.630680192762735e+02 -3.632255260890885e+02 -3.633830837209757e+02 -3.635406923518125e+02 -3.636983521500620e+02 + -3.638560629437486e+02 -3.640138245654421e+02 -3.641716372063300e+02 -3.643295010634408e+02 -3.644874159985495e+02 + -3.646453818454157e+02 -3.648033986609884e+02 -3.649614665547653e+02 -3.651195856232492e+02 -3.652777559169987e+02 + -3.654359773157880e+02 -3.655942497193339e+02 -3.657525732779061e+02 -3.659109481367831e+02 -3.660693741707290e+02 + -3.662278512419212e+02 -3.663863794327037e+02 -3.665449588644519e+02 -3.667035895945005e+02 -3.668622716357800e+02 + -3.670210048876434e+02 -3.671797892763418e+02 -3.673386249492966e+02 -3.674975120447079e+02 -3.676564504427247e+02 + -3.678154400208724e+02 -3.679744809042344e+02 -3.681335732252156e+02 -3.682927168979475e+02 -3.684519118222935e+02 + -3.686111580593141e+02 -3.687704557033292e+02 -3.689298048205014e+02 -3.690892054329191e+02 -3.692486574145354e+02 + -3.694081606700869e+02 -3.695677153755793e+02 -3.697273216946131e+02 -3.698869794698993e+02 -3.700466885253786e+02 + -3.702064489307988e+02 -3.703662608017668e+02 -3.705261241915196e+02 -3.706860391012269e+02 -3.708460053861607e+02 + -3.710060229388483e+02 -3.711660919467376e+02 -3.713262125796104e+02 -3.714863846416646e+02 -3.716466079328989e+02 + -3.718068826020972e+02 -3.719672088201144e+02 -3.721275864973102e+02 -3.722880155098476e+02 -3.724484958575989e+02 + -3.726090275883345e+02 -3.727696108177087e+02 -3.729302456171431e+02 -3.730909318132427e+02 -3.732516692484294e+02 + -3.734124580732086e+02 -3.735732984485285e+02 -3.737341902690280e+02 -3.738951333966488e+02 -3.740561278288502e+02 + -3.742171736164895e+02 -3.743782708884933e+02 -3.745394197314636e+02 -3.747006199846337e+02 -3.748618715145197e+02 + -3.750231745441332e+02 -3.751845292967938e+02 -3.753459356405600e+02 -3.755073934398666e+02 -3.756689028999150e+02 + -3.758304642401999e+02 -3.759920773966298e+02 -3.761537422764503e+02 -3.763154589558405e+02 -3.764772275566993e+02 + -3.766390482148706e+02 -3.768009210261144e+02 -3.769628459119104e+02 -3.771248228066682e+02 -3.772868518707951e+02 + -3.774489332703654e+02 -3.776110669681248e+02 -3.777732529036114e+02 -3.779354911268638e+02 -3.780977817328078e+02 + -3.782601248854201e+02 -3.784225207068740e+02 -3.785849690830777e+02 -3.787474699201715e+02 -3.789100234414875e+02 + -3.790726298611719e+02 -3.792352890394379e+02 -3.793980008403989e+02 -3.795607654977005e+02 -3.797235832511840e+02 + -3.798864539959452e+02 -3.800493775732837e+02 -3.802123539540593e+02 -3.803753831256555e+02 -3.805384650119894e+02 + -3.807015994897982e+02 -3.808647863105625e+02 -3.810280252452890e+02 -3.811913162683451e+02 -3.813546593533040e+02 + -3.815180542672069e+02 -3.816815007606327e+02 -3.818449987248433e+02 -3.820085480876401e+02 -3.821721487823003e+02 + -3.823358007029311e+02 -3.824995035814819e+02 -3.826632571794644e+02 -3.828270615387958e+02 -3.829909166775790e+02 + -3.831548222382581e+02 -3.833187778788636e+02 -3.834827836954302e+02 -3.836468397830658e+02 -3.838109457951704e+02 + -3.839751013606573e+02 -3.841393064522010e+02 -3.843035610985582e+02 -3.844678652090594e+02 -3.846322186342679e+02 + -3.847966211091070e+02 -3.849610723938522e+02 -3.851255724658270e+02 -3.852901213276589e+02 -3.854547188661456e+02 + -3.856193651039130e+02 -3.857840607227301e+02 -3.859488064858506e+02 -3.861136028233281e+02 -3.862784501283425e+02 + -3.864433489797775e+02 -3.866083000045549e+02 -3.867733038360474e+02 -3.869383610689728e+02 -3.871034721369783e+02 + -3.872686374886131e+02 -3.874338577931016e+02 -3.875991337168530e+02 -3.877644656943423e+02 -3.879298541437876e+02 + -3.880952996503134e+02 -3.882608028487801e+02 -3.884263644060860e+02 -3.885919849359946e+02 -3.887576648076931e+02 + -3.889234044110585e+02 -3.890892044633024e+02 -3.892550656828005e+02 -3.894209884652491e+02 -3.895869732058733e+02 + -3.897530206206903e+02 -3.899191314265681e+02 -3.900853060229904e+02 -3.902515447813749e+02 -3.904178482782592e+02 + -3.905842171832736e+02 -3.907506523333024e+02 -3.909171542011455e+02 -3.910837216360146e+02 -3.912503530200719e+02 + -3.914170464908692e+02 -3.915838000867597e+02 -3.917506116939103e+02 -3.919174791997058e+02 -3.920844006485843e+02 + -3.922513741233318e+02 -3.924183977030698e+02 -3.925854694180132e+02 -3.927525871064144e+02 -3.929197486330507e+02 + -3.930869521607613e+02 -3.932541958513385e+02 -3.934214775643266e+02 -3.935887951493436e+02 -3.937561467185514e+02 + -3.939235303999417e+02 -3.940909441222876e+02 -3.942583857858931e+02 -3.944258533764072e+02 -3.945933449213566e+02 + -3.947608585304349e+02 -3.949283922804248e+02 -3.950959440342958e+02 -3.952635116636291e+02 -3.954310932882606e+02 + -3.955986870327357e+02 -3.957662907921835e+02 -3.959339024467546e+02 -3.961015200461023e+02 -3.962691416638499e+02 + 1.070000000000000e-01 1.069682658750319e-01 1.069365186252596e-01 1.069047582677665e-01 1.068729848196356e-01 + 1.068411982979503e-01 1.068093987197937e-01 1.067775861022493e-01 1.067457604624000e-01 1.067139218173294e-01 + 1.066820701841205e-01 1.066502055798566e-01 1.066183280216209e-01 1.065864375264968e-01 1.065545341115673e-01 + 1.065226177939159e-01 1.064906885906257e-01 1.064587465187799e-01 1.064267915954618e-01 1.063948238377547e-01 + 1.063628432627417e-01 1.063308498875062e-01 1.062988437291314e-01 1.062668248047005e-01 1.062347931312967e-01 + 1.062027487260033e-01 1.061706916059036e-01 1.061386217880807e-01 1.061065392896180e-01 1.060744441275985e-01 + 1.060423363191058e-01 1.060102158812228e-01 1.059780828310330e-01 1.059459371856195e-01 1.059137789620655e-01 + 1.058816081774544e-01 1.058494248488693e-01 1.058172289933936e-01 1.057850206281103e-01 1.057527997701029e-01 + 1.057205664364545e-01 1.056883206442483e-01 1.056560624105677e-01 1.056237917524958e-01 1.055915086871159e-01 + 1.055592132315112e-01 1.055269054027650e-01 1.054945852179606e-01 1.054622526941811e-01 1.054299078485097e-01 + 1.053975506980299e-01 1.053651812598247e-01 1.053327995509774e-01 1.053004055885713e-01 1.052679993896897e-01 + 1.052355809714157e-01 1.052031503508325e-01 1.051707075450236e-01 1.051382525710719e-01 1.051057854460610e-01 + 1.050733061870738e-01 1.050408148111938e-01 1.050083113355042e-01 1.049757957770881e-01 1.049432681530288e-01 + 1.049107284804097e-01 1.048781767763138e-01 1.048456130578245e-01 1.048130373420250e-01 1.047804496459986e-01 + 1.047478499868284e-01 1.047152383815977e-01 1.046826148473898e-01 1.046499794012880e-01 1.046173320603753e-01 + 1.045846728417352e-01 1.045520017624508e-01 1.045193188396054e-01 1.044866240902822e-01 1.044539175315645e-01 + 1.044211991805354e-01 1.043884690542783e-01 1.043557271698764e-01 1.043229735444130e-01 1.042902081949712e-01 + 1.042574311386343e-01 1.042246423924855e-01 1.041918419736082e-01 1.041590298990855e-01 1.041262061860007e-01 + 1.040933708514369e-01 1.040605239124776e-01 1.040276653862059e-01 1.039947952897050e-01 1.039619136400582e-01 + 1.039290204543487e-01 1.038961157496599e-01 1.038631995430748e-01 1.038302718516768e-01 1.037973326925491e-01 + 1.037643820827749e-01 1.037314200394375e-01 1.036984465796201e-01 1.036654617204061e-01 1.036324654788785e-01 + 1.035994578721206e-01 1.035664389172158e-01 1.035334086312472e-01 1.035003670312980e-01 1.034673141344516e-01 + 1.034342499577912e-01 1.034011745183999e-01 1.033680878333612e-01 1.033349899197580e-01 1.033018807946739e-01 + 1.032687604751918e-01 1.032356289783953e-01 1.032024863213673e-01 1.031693325211913e-01 1.031361675949504e-01 + 1.031029915597278e-01 1.030698044326069e-01 1.030366062306709e-01 1.030033969710030e-01 1.029701766706864e-01 + 1.029369453468044e-01 1.029037030164402e-01 1.028704496966771e-01 1.028371854045984e-01 1.028039101572872e-01 + 1.027706239718267e-01 1.027373268653004e-01 1.027040188547913e-01 1.026706999573827e-01 1.026373701901580e-01 + 1.026040295702002e-01 1.025706781145926e-01 1.025373158404186e-01 1.025039427647613e-01 1.024705589047040e-01 + 1.024371642773299e-01 1.024037588997223e-01 1.023703427889643e-01 1.023369159621393e-01 1.023034784363305e-01 + 1.022700302286212e-01 1.022365713560945e-01 1.022031018358337e-01 1.021696216849221e-01 1.021361309204428e-01 + 1.021026295594792e-01 1.020691176191145e-01 1.020355951164319e-01 1.020020620685147e-01 1.019685184924461e-01 + 1.019349644053093e-01 1.019013998241876e-01 1.018678247661643e-01 1.018342392483225e-01 1.018006432877456e-01 + 1.017670369015167e-01 1.017334201067191e-01 1.016997929204361e-01 1.016661553597508e-01 1.016325074417466e-01 + 1.015988491835066e-01 1.015651806021141e-01 1.015315017146524e-01 1.014978125382047e-01 1.014641130898543e-01 + 1.014304033866843e-01 1.013966834457780e-01 1.013629532842187e-01 1.013292129190896e-01 1.012954623674739e-01 + 1.012617016464549e-01 1.012279307731159e-01 1.011941497645400e-01 1.011603586378106e-01 1.011265574100107e-01 + 1.010927460982239e-01 1.010589247195331e-01 1.010250932910217e-01 1.009912518297729e-01 1.009574003528701e-01 + 1.009235388773963e-01 1.008896674204348e-01 1.008557859990690e-01 1.008218946303820e-01 1.007879933314571e-01 + 1.007540821193774e-01 1.007201610112264e-01 1.006862300240872e-01 1.006522891750429e-01 1.006183384811770e-01 + 1.005843779595726e-01 1.005504076273130e-01 1.005164275014813e-01 1.004824375991610e-01 1.004484379374351e-01 + 1.004144285333870e-01 1.003804094040999e-01 1.003463805666569e-01 1.003123420381414e-01 1.002782938356367e-01 + 1.002442359762259e-01 1.002101684769922e-01 1.001760913550190e-01 1.001420046273895e-01 1.001079083111869e-01 + 1.000738024234945e-01 1.000396869813954e-01 1.000055620019730e-01 9.997142750231042e-02 9.993728349949102e-02 + 9.990313001059796e-02 9.986896705271456e-02 9.983479464292398e-02 9.980061279830947e-02 9.976642153595434e-02 + 9.973222087294174e-02 9.969801082635499e-02 9.966379141327726e-02 9.962956265079187e-02 9.959532455598200e-02 + 9.956107714593093e-02 9.952682043772192e-02 9.949255444843813e-02 9.945827919516288e-02 9.942399469497937e-02 + 9.938970096497086e-02 9.935539802222057e-02 9.932108588381178e-02 9.928676456682770e-02 9.925243408835159e-02 + 9.921809446546671e-02 9.918374571525623e-02 9.914938785480347e-02 9.911502090119163e-02 9.908064487150398e-02 + 9.904625978282372e-02 9.901186565223413e-02 9.897746249681845e-02 9.894305033365988e-02 9.890862917984172e-02 + 9.887419905244718e-02 9.883975996855951e-02 9.880531194526194e-02 9.877085499963774e-02 9.873638914877009e-02 + 9.870191440974231e-02 9.866743079963761e-02 9.863293833553920e-02 9.859843703453038e-02 9.856392691369432e-02 + 9.852940799011436e-02 9.849488028087365e-02 9.846034380305550e-02 9.842579857374308e-02 9.839124461001970e-02 + 9.835668192896858e-02 9.832211054767293e-02 9.828753048321603e-02 9.825294175268109e-02 9.821834437315143e-02 + 9.818373836171017e-02 9.814912373544066e-02 9.811450051142606e-02 9.807986870674969e-02 9.804522833849474e-02 + 9.801057942374444e-02 9.797592197958208e-02 9.794125602309085e-02 9.790658157135405e-02 9.787189864145487e-02 + 9.783720725047659e-02 9.780250741550246e-02 9.776779915361565e-02 9.773308248189948e-02 9.769835741743713e-02 + 9.766362397731190e-02 9.762888217860698e-02 9.759413203840565e-02 9.755937357379113e-02 9.752460680184671e-02 + 9.748983173965557e-02 9.745504840430097e-02 9.742025681286617e-02 9.738545698243438e-02 9.735064893008888e-02 + 9.731583267291286e-02 9.728100822798963e-02 9.724617561240236e-02 9.721133484323437e-02 9.717648593756885e-02 + 9.714162891248904e-02 9.710676378507821e-02 9.707189057241956e-02 9.703700929159639e-02 9.700211995969188e-02 + 9.696722259378933e-02 9.693231721097194e-02 9.689740382832296e-02 9.686248246292567e-02 9.682755313186324e-02 + 9.679261585221899e-02 9.675767064107609e-02 9.672271751551782e-02 9.668775649262741e-02 9.665278758948814e-02 + 9.661781082318323e-02 9.658282621079586e-02 9.654783376940938e-02 9.651283351610694e-02 9.647782546797186e-02 + 9.644280964208730e-02 9.640778605553657e-02 9.637275472540287e-02 9.633771566876947e-02 9.630266890271960e-02 + 9.626761444433649e-02 9.623255231070338e-02 9.619748251890356e-02 9.616240508602021e-02 9.612732002913663e-02 + 9.609222736533599e-02 9.605712711170160e-02 9.602201928531666e-02 9.598690390326445e-02 9.595178098262819e-02 + 9.591665054049109e-02 9.588151259393644e-02 9.584636716004745e-02 9.581121425590743e-02 9.577605389859950e-02 + 9.574088610520702e-02 9.570571089281314e-02 9.567052827850117e-02 9.563533827935435e-02 9.560014091245586e-02 + 9.556493619488900e-02 9.552972414373699e-02 9.549450477608308e-02 9.545927810901049e-02 9.542404415960248e-02 + 9.538880294494230e-02 9.535355448211316e-02 9.531829878819836e-02 9.528303588028109e-02 9.524776577544461e-02 + 9.521248849077216e-02 9.517720404334697e-02 9.514191245025229e-02 9.510661372857139e-02 9.507130789538748e-02 + 9.503599496778380e-02 9.500067496284360e-02 9.496534789765015e-02 9.493001378928664e-02 9.489467265483635e-02 + 9.485932451138250e-02 9.482396937600834e-02 9.478860726579713e-02 9.475323819783207e-02 9.471786218919645e-02 + 9.468247925697347e-02 9.464708941824643e-02 9.461169269009850e-02 9.457628908961296e-02 9.454087863387305e-02 + 9.450546133996199e-02 9.447003722496307e-02 9.443460630595948e-02 9.439916860003450e-02 9.436372412427137e-02 + 9.432827289575330e-02 9.429281493156354e-02 9.425735024878537e-02 9.422187886450198e-02 9.418640079579664e-02 + 9.415091605975259e-02 9.411542467345307e-02 9.407992665398136e-02 9.404442201842063e-02 9.400891078385415e-02 + 9.397339296736518e-02 9.393786858603695e-02 9.390233765695270e-02 9.386680019719568e-02 9.383125622384911e-02 + 9.379570575399625e-02 9.376014880472036e-02 9.372458539310466e-02 9.368901553623238e-02 9.365343925118678e-02 + 9.361785655505112e-02 9.358226746490858e-02 9.354667199784246e-02 9.351107017093598e-02 9.347546200127239e-02 + 9.343984750593494e-02 9.340422670200685e-02 9.336859960657137e-02 9.333296623671174e-02 9.329732660951121e-02 + 9.326168074205300e-02 9.322602865142039e-02 9.319037035469660e-02 9.315470586896488e-02 9.311903521130845e-02 + 9.308335839881057e-02 9.304767544855448e-02 9.301198637762342e-02 9.297629120310064e-02 9.294058994206936e-02 + 9.290488261161287e-02 9.286916922881436e-02 9.283344981075708e-02 9.279772437452428e-02 9.276199293719922e-02 + 9.272625551586512e-02 9.269051212760523e-02 9.265476278950278e-02 9.261900751864104e-02 9.258324633210324e-02 + 9.254747924697261e-02 9.251170628033240e-02 9.247592744926583e-02 9.244014277085617e-02 9.240435226218666e-02 + 9.236855594034055e-02 9.233275382240104e-02 9.229694592545142e-02 9.226113226657491e-02 9.222531286285476e-02 + 9.218948773137420e-02 9.215365688921646e-02 9.211782035346482e-02 9.208197814120249e-02 9.204613026951274e-02 + 9.201027675547878e-02 9.197441761618388e-02 9.193855286871126e-02 9.190268253014419e-02 9.186680661756588e-02 + 9.183092514805957e-02 9.179503813870854e-02 9.175914560659600e-02 9.172324756880521e-02 9.168734404241941e-02 + 9.165143504452181e-02 9.161552059219569e-02 9.157960070252427e-02 9.154367539259080e-02 9.150774467947854e-02 + 9.147180858027071e-02 9.143586711205055e-02 9.139992029190132e-02 9.136396813690625e-02 9.132801066414858e-02 + 9.129204789071155e-02 9.125607983367841e-02 9.122010651013239e-02 9.118412793715676e-02 9.114814413183472e-02 + 9.111215511124955e-02 9.107616089248448e-02 9.104016149262276e-02 9.100415692874760e-02 9.096814721794225e-02 + 9.093213237728998e-02 9.089611242387401e-02 9.086008737477760e-02 9.082405724708396e-02 9.078802205787638e-02 + 9.075198182423806e-02 9.071593656325225e-02 9.067988629200220e-02 9.064383102757116e-02 9.060777078704237e-02 + 9.057170558749904e-02 9.053563544602444e-02 9.049956037970180e-02 9.046348040561442e-02 9.042739554084545e-02 + 9.039130580247817e-02 9.035521120759583e-02 9.031911177328168e-02 9.028300751661894e-02 9.024689845469086e-02 + 9.021078460458068e-02 9.017466598337168e-02 9.013854260814702e-02 9.010241449599002e-02 9.006628166398388e-02 + 9.003014412921184e-02 8.999400190875718e-02 8.995785501970310e-02 8.992170347913286e-02 8.988554730412972e-02 + 8.984938651177689e-02 8.981322111915761e-02 8.977705114335516e-02 8.974087660145275e-02 8.970469751053363e-02 + 8.966851388768103e-02 8.963232574997822e-02 8.959613311450842e-02 8.955993599835491e-02 8.952373441860086e-02 + 8.948752839232957e-02 8.945131793662427e-02 8.941510306856817e-02 8.937888380524456e-02 8.934266016373665e-02 + 8.930643216112769e-02 8.927019981450095e-02 8.923396314093963e-02 8.919772215752698e-02 8.916147688134625e-02 + 8.912522732948071e-02 8.908897351901354e-02 8.905271546702803e-02 8.901645319060740e-02 8.898018670683491e-02 + 8.894391603279379e-02 8.890764118556729e-02 8.887136218223864e-02 8.883507903989107e-02 8.879879177560786e-02 + 8.876250040647221e-02 8.872620494956741e-02 8.868990542197666e-02 8.865360184078323e-02 8.861729422307035e-02 + 8.858098258592126e-02 8.854466694641919e-02 8.850834732164740e-02 8.847202372868912e-02 8.843569618462761e-02 + 8.839936470654611e-02 8.836302931152785e-02 8.832669001665606e-02 8.829034683901400e-02 8.825399979568492e-02 + 8.821764890375206e-02 8.818129418029862e-02 8.814493564240788e-02 8.810857330716310e-02 8.807220719164749e-02 + 8.803583731294432e-02 8.799946368813677e-02 8.796308633430815e-02 8.792670526854167e-02 8.789032050792057e-02 + 8.785393206952812e-02 8.781753997044753e-02 8.778114422776205e-02 8.774474485855495e-02 8.770834187990943e-02 + 8.767193530890875e-02 8.763552516263615e-02 8.759911145817488e-02 8.756269421260816e-02 8.752627344301928e-02 + 8.748984916649143e-02 8.745342140010788e-02 8.741699016095185e-02 8.738055546610660e-02 8.734411733265539e-02 + 8.730767577768141e-02 8.727123081826793e-02 8.723478247149821e-02 8.719833075445547e-02 8.716187568422298e-02 + 8.712541727788393e-02 8.708895555252159e-02 8.705249052521923e-02 8.701602221306004e-02 8.697955063312730e-02 + 8.694307580250422e-02 8.690659773827408e-02 8.687011645752010e-02 8.683363197732555e-02 8.679714431477362e-02 + 8.676065348694757e-02 8.672415951093065e-02 8.668766240380611e-02 8.665116218265721e-02 8.661465886456714e-02 + 8.657815246661917e-02 8.654164300589655e-02 8.650513049948251e-02 8.646861496446030e-02 8.643209641791315e-02 + 8.639557487692430e-02 8.635905035857701e-02 8.632252287995451e-02 8.628599245814005e-02 8.624945911021686e-02 + 8.621292285326819e-02 8.617638370437727e-02 8.613984168062737e-02 8.610329679910171e-02 8.606674907688353e-02 + 8.603019853105608e-02 8.599364517870259e-02 8.595708903690633e-02 8.592053012275053e-02 8.588396845331842e-02 + 8.584740404569323e-02 8.581083691695822e-02 8.577426708419665e-02 8.573769456449173e-02 8.570111937492672e-02 + 8.566454153258486e-02 8.562796105454940e-02 8.559137795790356e-02 8.555479225973059e-02 8.551820397711374e-02 + 8.548161312713624e-02 8.544501972688134e-02 8.540842379343229e-02 8.537182534387232e-02 8.533522439528468e-02 + 8.529862096475260e-02 8.526201506935933e-02 8.522540672618811e-02 8.518879595232219e-02 8.515218276484479e-02 + 8.511556718083918e-02 8.507894921738858e-02 8.504232889157626e-02 8.500570622048544e-02 8.496908122119934e-02 + 8.493245391080124e-02 8.489582430637438e-02 8.485919242500198e-02 8.482255828376728e-02 8.478592189975355e-02 + 8.474928329004400e-02 8.471264247172190e-02 8.467599946187047e-02 8.463935427757298e-02 8.460270693591267e-02 + 8.456605745397273e-02 8.452940584883646e-02 8.449275213758706e-02 8.445609633730780e-02 8.441943846508193e-02 + 8.438277853799266e-02 8.434611657312326e-02 8.430945258755695e-02 8.427278659837699e-02 8.423611862266661e-02 + 8.419944867750905e-02 8.416277677998756e-02 8.412610294718537e-02 8.408942719618576e-02 8.405274954407191e-02 + 8.401607000792713e-02 8.397938860483460e-02 8.394270535187759e-02 8.390602026613936e-02 8.386933336470312e-02 + 8.383264466465212e-02 8.379595418306962e-02 8.375926193703884e-02 8.372256794364304e-02 8.368587221996546e-02 + 8.364917478308932e-02 8.361247565009787e-02 8.357577483807437e-02 8.353907236410206e-02 8.350236824526415e-02 + 8.346566249864391e-02 8.342895514132459e-02 8.339224619038943e-02 8.335553566292164e-02 8.331882357600448e-02 + 8.328210994672121e-02 8.324539479215504e-02 8.320867812938924e-02 8.317195997550704e-02 8.313524034759166e-02 + 8.309851926272641e-02 8.306179673799445e-02 8.302507279047908e-02 8.298834743726349e-02 8.295162069543097e-02 + 8.291489258206473e-02 8.287816311424805e-02 8.284143230906414e-02 8.280470018359624e-02 8.276796675492762e-02 + 8.273123204014149e-02 8.269449605632111e-02 8.265775882054972e-02 8.262102034991055e-02 8.258428066148686e-02 + 8.254753977236187e-02 8.251079769961885e-02 8.247405446034105e-02 8.243731007161166e-02 8.240056455051395e-02 + 8.236381791413117e-02 8.232707017954656e-02 8.229032136384334e-02 8.225357148410478e-02 8.221682055741411e-02 + 8.218006860085458e-02 8.214331563150944e-02 8.210656166646188e-02 8.206980672279519e-02 8.203305081759260e-02 + 8.199629396793737e-02 8.195953619091272e-02 8.192277750360188e-02 8.188601792308813e-02 8.184925746645468e-02 + 8.181249615078479e-02 8.177573399316168e-02 8.173897101066861e-02 8.170220722038883e-02 8.166544263940556e-02 + 8.162867728480205e-02 8.159191117366156e-02 8.155514432306732e-02 8.151837675010254e-02 8.148160847185050e-02 + 8.144483950539445e-02 8.140806986781760e-02 8.137129957620320e-02 8.133452864763450e-02 8.129775709919475e-02 + 8.126098494796720e-02 8.122421221103504e-02 8.118743890548155e-02 8.115066504838998e-02 8.111389065684355e-02 + 8.107711574792552e-02 8.104034033871912e-02 8.100356444630759e-02 8.096678808777417e-02 8.093001128020215e-02 + 8.089323404067471e-02 8.085645638627510e-02 8.081967833408658e-02 8.078289990119239e-02 8.074612110467576e-02 + 8.070934196161997e-02 8.067256248910820e-02 8.063578270422375e-02 8.059900262404983e-02 8.056222226566968e-02 + 8.052544164616657e-02 8.048866078262369e-02 8.045187969212433e-02 8.041509839175172e-02 8.037831689858911e-02 + 8.034153522971973e-02 8.030475340222681e-02 8.026797143319361e-02 8.023118933970336e-02 8.019440713883932e-02 + 8.015762484768471e-02 8.012084248332278e-02 8.008406006283678e-02 8.004727760330994e-02 8.001049512182555e-02 + 7.997371263546676e-02 7.993693016131688e-02 7.990014771645915e-02 7.986336531797676e-02 7.982658298295300e-02 + 7.978980072847111e-02 7.975301857161432e-02 7.971623652946590e-02 7.967945461910902e-02 7.964267285762699e-02 + 7.960589126210302e-02 7.956910984962039e-02 7.953232863726228e-02 7.949554764211197e-02 7.945876688125271e-02 + 7.942198637176773e-02 7.938520613074028e-02 7.934842617525358e-02 7.931164652239087e-02 7.927486718923542e-02 + 7.923808819287045e-02 7.920130955037924e-02 7.916453127884499e-02 7.912775339535094e-02 7.909097591698037e-02 + 7.905419886081648e-02 7.901742224394255e-02 7.898064608344180e-02 7.894387039639746e-02 7.890709519989279e-02 + 7.887032051101103e-02 7.883354634683543e-02 7.879677272444922e-02 7.875999966093565e-02 7.872322717337794e-02 + 7.868645527885937e-02 7.864968399446313e-02 7.861291333727252e-02 7.857614332437074e-02 7.853937397284104e-02 + 7.850260529976670e-02 7.846583732223091e-02 7.842907005731693e-02 7.839230352210801e-02 7.835553773368738e-02 + 7.831877270913830e-02 7.828200846554398e-02 7.824524501998768e-02 7.820848238955266e-02 7.817172059132216e-02 + 7.813495964237939e-02 7.809819955980761e-02 7.806144036069006e-02 7.802468206210998e-02 7.798792468115062e-02 + 7.795116823489523e-02 7.791441274042703e-02 7.787765821482928e-02 7.784090467518520e-02 7.780415213857807e-02 + 7.776740062209107e-02 7.773065014280750e-02 7.769390071781057e-02 7.765715236418354e-02 7.762040509900967e-02 + 7.758365893937215e-02 7.754691390235426e-02 7.751017000503922e-02 7.747342726451029e-02 7.743668569785070e-02 + 7.739994532214370e-02 7.736320615447252e-02 7.732646821192042e-02 7.728973151157063e-02 7.725299607050642e-02 + 7.721626190581099e-02 7.717952903456758e-02 7.714279747385946e-02 7.710606724076986e-02 7.706933835238206e-02 + 7.703261082577922e-02 7.699588467804465e-02 7.695915992626157e-02 7.692243658751323e-02 7.688571467888285e-02 + 7.684899421745368e-02 7.681227522030898e-02 7.677555770453198e-02 7.673884168720593e-02 7.670212718541405e-02 + 7.666541421623961e-02 7.662870279676583e-02 7.659199294407595e-02 7.655528467525324e-02 7.651857800738091e-02 + 7.648187295754222e-02 7.644516954282041e-02 7.640846778029871e-02 7.637176768706039e-02 7.633506928018867e-02 + 7.629837257676678e-02 7.626167759387799e-02 7.622498434860552e-02 7.618829285803264e-02 7.615160313924255e-02 + 7.611491520931853e-02 7.607822908534380e-02 7.604154478440163e-02 7.600486232357523e-02 7.596818171994783e-02 + 7.593150299060271e-02 7.589482615262309e-02 7.585815122309225e-02 7.582147821909338e-02 7.578480715770973e-02 + 7.574813805602458e-02 7.571147093112113e-02 7.567480580008265e-02 7.563814267999236e-02 7.560148158793352e-02 + 7.556482254098935e-02 7.552816555624312e-02 7.549151065077807e-02 7.545485784167741e-02 7.541820714602442e-02 + 7.538155858090231e-02 7.534491216339434e-02 7.530826791058375e-02 7.527162583955378e-02 7.523498596738766e-02 + 7.519834831116866e-02 7.516171288797999e-02 7.512507971490495e-02 7.508844880902671e-02 7.505182018742854e-02 + 7.501519386719367e-02 7.497856986540538e-02 7.494194819914687e-02 7.490532888550142e-02 7.486871194155223e-02 + 7.483209738438257e-02 7.479548523107570e-02 7.475887549871482e-02 7.472226820438319e-02 7.468566336516404e-02 + 7.464906099814063e-02 7.461246112039621e-02 7.457586374901400e-02 7.453926890107723e-02 7.450267659366919e-02 + 7.446608684387307e-02 7.442949966877216e-02 7.439291508544965e-02 7.435633311098883e-02 7.431975376247291e-02 + 7.428317705698513e-02 7.424660301160878e-02 7.421003164342704e-02 7.417346296952319e-02 7.413689700698045e-02 + 7.410033377288210e-02 7.406377328431132e-02 7.402721555835140e-02 7.399066061208556e-02 7.395410846259706e-02 + 7.391755912696915e-02 7.388101262228504e-02 7.384446896562798e-02 7.380792817408122e-02 7.377139026472800e-02 + 7.373485525465158e-02 7.369832316093516e-02 7.366179400066203e-02 7.362526779091538e-02 7.358874454877849e-02 + 7.355222429133459e-02 7.351570703566694e-02 7.347919279885876e-02 7.344268159799329e-02 7.340617345015378e-02 + 7.336966837242348e-02 7.333316638188561e-02 7.329666749562345e-02 7.326017173072021e-02 7.322367910425913e-02 + 7.318718963332346e-02 7.315070333499644e-02 7.311422022636133e-02 7.307774032450136e-02 7.304126364649975e-02 + 7.300479020943977e-02 7.296832003040465e-02 7.293185312647765e-02 7.289538951474199e-02 7.285892921228092e-02 + 7.282247223617767e-02 7.278601860351550e-02 7.274956833137766e-02 7.271312143684736e-02 7.267667793700786e-02 + 7.264023784894239e-02 7.260380118973422e-02 7.256736797646657e-02 7.253093822622268e-02 7.249451195608582e-02 + 7.245808918313920e-02 7.242166992446607e-02 7.238525419714967e-02 7.234884201827325e-02 7.231243340492007e-02 + 7.227602837417331e-02 7.223962694311627e-02 7.220322912883217e-02 7.216683494840427e-02 7.213044441891579e-02 + 7.209405755744998e-02 7.205767438109009e-02 7.202129490691934e-02 7.198491915202099e-02 7.194854713347830e-02 + 7.191217886837446e-02 7.187581437379276e-02 7.183945366681642e-02 7.180309676452867e-02 7.176674368401278e-02 + 7.173039444235199e-02 7.169404905662952e-02 7.165770754392863e-02 7.162136992133256e-02 7.158503620592453e-02 + 7.154870641478780e-02 7.151238056500563e-02 7.147605867366123e-02 7.143974075783785e-02 7.140342683461876e-02 + 7.136711692108716e-02 7.133081103432631e-02 7.129450919141947e-02 7.125821140944985e-02 7.122191770550071e-02 + 7.118562809665530e-02 7.114934259999683e-02 7.111306123260858e-02 7.107678401157377e-02 7.104051095397565e-02 + 7.100424207689746e-02 7.096797739742244e-02 7.093171693263382e-02 7.089546069961486e-02 7.085920871544882e-02 + 7.082296099721888e-02 7.078671756200834e-02 7.075047842690044e-02 7.071424360897838e-02 7.067801312532543e-02 + 7.064178699302483e-02 7.060556522915983e-02 7.056934785081363e-02 7.053313487506954e-02 7.049692631901075e-02 + 7.046072219972052e-02 7.042452253428211e-02 7.038832733977872e-02 7.035213663329361e-02 7.031595043191004e-02 + 7.027976875271123e-02 7.024359161278042e-02 7.020741902920087e-02 7.017125101905583e-02 7.013508759942851e-02 + 7.009892878740216e-02 7.006277460006004e-02 7.002662505448538e-02 6.999048016776144e-02 6.995433995697144e-02 + 6.991820443919861e-02 6.988207363152622e-02 6.984594755103750e-02 6.980982621481568e-02 6.977370963994402e-02 + 6.973759784350578e-02 6.970149084258416e-02 6.966538865426242e-02 6.962929129562380e-02 6.959319878375156e-02 + 6.955711113572893e-02 6.952102836863913e-02 6.948495049956542e-02 6.944887754559105e-02 6.941280952379927e-02 + 6.937674645127329e-02 6.934068834509637e-02 6.930463522235174e-02 6.926858710012268e-02 6.923254399549238e-02 + 6.919650592554411e-02 6.916047290736112e-02 6.912444495802665e-02 6.908842209462392e-02 6.905240433423616e-02 + 6.901639169394666e-02 6.898038419083864e-02 6.894438184199533e-02 6.890838466449999e-02 6.887239267543585e-02 + 6.883640589188617e-02 6.880042433093415e-02 6.876444800966307e-02 6.872847694515619e-02 6.869251115449670e-02 + 6.865655065476786e-02 6.862059546305292e-02 6.858464559643512e-02 6.854870107199770e-02 6.851276190682393e-02 + 6.847682811799699e-02 6.844089972260017e-02 6.840497673771671e-02 6.836905918042983e-02 6.833314706782279e-02 + 6.829724041697882e-02 6.826133924498116e-02 6.822544356891308e-02 6.818955340585779e-02 6.815366877289854e-02 + 6.811778968711857e-02 6.808191616560114e-02 6.804604822542948e-02 6.801018588368681e-02 6.797432915745642e-02 + 6.793847806382150e-02 6.790263261986533e-02 6.786679284267115e-02 6.783095874932217e-02 6.779513035690166e-02 + 6.775930768249286e-02 6.772349074317900e-02 6.768767955604332e-02 6.765187413816909e-02 6.761607450663952e-02 + 6.758028067853786e-02 6.754449267094738e-02 6.750871050095128e-02 6.747293418563281e-02 6.743716374207524e-02 + 6.740139918736179e-02 6.736564053857570e-02 6.732988781280023e-02 6.729414102711860e-02 6.725840019861405e-02 + 6.722266534436987e-02 6.718693648146923e-02 6.715121362699542e-02 6.711549679803168e-02 6.707978601166123e-02 + 6.704408128496732e-02 6.700838263503321e-02 6.697269007894212e-02 6.693700363377729e-02 6.690132331662198e-02 + 6.686564914455943e-02 6.682998113467287e-02 6.679431930404556e-02 6.675866366976070e-02 6.672301424890158e-02 + 6.668737105855144e-02 6.665173411579348e-02 6.661610343771096e-02 6.658047904138716e-02 6.654486094390526e-02 + 6.650924916234854e-02 6.647364371380024e-02 6.643804461534360e-02 6.640245188406185e-02 6.636686553703826e-02 + 6.633128559135604e-02 6.629571206409844e-02 6.626014497234871e-02 6.622458433319009e-02 6.618903016370581e-02 + 6.615348248097914e-02 6.611794130209329e-02 6.608240664413152e-02 6.604687852417708e-02 6.601135695931318e-02 + 6.597584196662311e-02 6.594033356319007e-02 6.590483176609731e-02 6.586933659242808e-02 6.583384805926563e-02 + 6.579836618369318e-02 6.576289098279399e-02 6.572742247365128e-02 6.569196067334833e-02 6.565650559896835e-02 + 6.562105726759460e-02 6.558561569631030e-02 6.555018090219872e-02 6.551475290234308e-02 6.547933171382664e-02 + 6.544391735373260e-02 6.540850983914427e-02 6.537310918714484e-02 6.533771541481756e-02 6.530232853924568e-02 + 6.526694857751246e-02 6.523157554670111e-02 6.519620946389489e-02 6.516085034617702e-02 6.512549821063078e-02 + 6.509015307433939e-02 6.505481495438609e-02 6.501948386785412e-02 6.498415983182672e-02 6.494884286338716e-02 + 6.491353297961865e-02 6.487823019760443e-02 6.484293453442776e-02 6.480764600717190e-02 6.477236463292005e-02 + 6.473709042875546e-02 6.470182341176141e-02 6.466656359902111e-02 6.463131100761778e-02 6.459606565463470e-02 + 6.456082755715510e-02 6.452559673226224e-02 6.449037319703932e-02 6.445515696856961e-02 6.441994806393636e-02 + 6.438474650022280e-02 6.434955229451217e-02 6.431436546388770e-02 6.427918602543267e-02 6.424401399623028e-02 + 6.420884939336380e-02 6.417369223391646e-02 6.413854253497149e-02 6.410340031361215e-02 6.406826558692170e-02 + 6.403313837198334e-02 6.399801868588033e-02 6.396290654569593e-02 6.392780196851335e-02 6.389270497141585e-02 + 6.385761557148667e-02 6.382253378580906e-02 6.378745963146625e-02 6.375239312554147e-02 6.371733428511799e-02 + 6.368228312727903e-02 6.364723966910786e-02 6.361220392768768e-02 6.357717592010177e-02 6.354215566343337e-02 + 6.350714317476568e-02 6.347213847118198e-02 6.343714156976551e-02 6.340215248759951e-02 6.336717124176720e-02 + 6.333219784935186e-02 6.329723232743668e-02 6.326227469310496e-02 6.322732496343991e-02 6.319238315552476e-02 + 6.315744928644278e-02 6.312252337327721e-02 6.308760543311126e-02 6.305269548302821e-02 6.301779354011129e-02 + 6.298289962144372e-02 6.294801374410877e-02 6.291313592518968e-02 6.287826618176968e-02 6.284340453093201e-02 + 6.280855098975993e-02 6.277370557533665e-02 6.273886830474544e-02 6.270403919506955e-02 6.266921826339220e-02 + 6.263440552679662e-02 6.259960100236607e-02 6.256480470718381e-02 6.253001665833306e-02 6.249523687289707e-02 + 6.246046536795907e-02 6.242570216060229e-02 6.239094726791002e-02 6.235620070696547e-02 6.232146249485187e-02 + 6.228673264865250e-02 6.225201118545055e-02 6.221729812232930e-02 6.218259347637199e-02 6.214789726466187e-02 + 6.211320950428215e-02 6.207853021231610e-02 6.204385940584693e-02 6.200919710195792e-02 6.197454331773228e-02 + 6.193989807025328e-02 6.190526137660414e-02 6.187063325386812e-02 6.183601371912845e-02 6.180140278946837e-02 + 6.176680048197113e-02 6.173220681371997e-02 6.169762180179813e-02 6.166304546328885e-02 6.162847781527538e-02 + 6.159391887484095e-02 6.155936865906880e-02 6.152482718504219e-02 6.149029446984435e-02 6.145577053055853e-02 + 6.142125538426796e-02 6.138674904805590e-02 6.135225153900557e-02 6.131776287420022e-02 6.128328307072310e-02 + 6.124881214565744e-02 6.121435011608650e-02 6.117989699909349e-02 6.114545281176169e-02 6.111101757117431e-02 + 6.107659129441460e-02 6.104217399856583e-02 6.100776570071121e-02 6.097336641793399e-02 6.093897616731742e-02 + 6.090459496594473e-02 6.087022283089916e-02 6.083585977926396e-02 6.080150582812238e-02 6.076716099455765e-02 + 6.073282529565302e-02 6.069849874849172e-02 6.066418137015700e-02 6.062987317773211e-02 6.059557418830027e-02 + 6.056128441894475e-02 6.052700388674876e-02 6.049273260879557e-02 6.045847060216841e-02 6.042421788395052e-02 + 6.038997447122514e-02 6.035574038107552e-02 6.032151563058490e-02 6.028730023683652e-02 6.025309421691362e-02 + 6.021889758789946e-02 6.018471036687725e-02 6.015053257093025e-02 6.011636421714171e-02 6.008220532259485e-02 + 6.004805590437293e-02 6.001391597955918e-02 5.997978556523686e-02 5.994566467848918e-02 5.991155333639943e-02 + 5.987745155605081e-02 5.984335935452657e-02 5.980927674890997e-02 5.977520375628423e-02 5.974114039373261e-02 + 5.970708667833834e-02 5.967304262718466e-02 5.963900825735483e-02 5.960498358593206e-02 5.957096862999962e-02 + 5.953696340664075e-02 5.950296793293869e-02 5.946898222597666e-02 5.943500630283793e-02 5.940104018060574e-02 + 5.936708387636331e-02 5.933313740719390e-02 5.929920079018074e-02 5.926527404240709e-02 5.923135718095618e-02 + 5.919745022291125e-02 5.916355318535554e-02 5.912966608537230e-02 5.909578894004478e-02 5.906192176645620e-02 + 5.902806458168981e-02 5.899421740282887e-02 5.896038024695659e-02 5.892655313115624e-02 5.889273607251104e-02 + 5.885892908810425e-02 5.882513219501910e-02 5.879134541033884e-02 5.875756875114671e-02 5.872380223452595e-02 + 5.869004587755981e-02 5.865629969733151e-02 5.862256371092430e-02 5.858883793542144e-02 5.855512238790617e-02 + 5.852141708546170e-02 5.848772204517131e-02 5.845403728411822e-02 5.842036281938568e-02 5.838669866805692e-02 + 5.835304484721521e-02 5.831940137394376e-02 5.828576826532585e-02 5.825214553844467e-02 5.821853321038349e-02 + 5.818493129822556e-02 5.815133981905412e-02 5.811775878995240e-02 5.808418822800365e-02 5.805062815029110e-02 + 5.801707857389801e-02 5.798353951590760e-02 5.795001099340315e-02 5.791649302346786e-02 5.788298562318499e-02 + 5.784948880963779e-02 5.781600259990949e-02 5.778252701108333e-02 5.774906206024256e-02 5.771560776447041e-02 + 5.768216414085015e-02 5.764873120646499e-02 5.761530897839819e-02 5.758189747373298e-02 5.754849670955262e-02 + 5.751510670294033e-02 5.748172747097936e-02 5.744835903075296e-02 5.741500139934437e-02 5.738165459383683e-02 + 5.734831863131357e-02 5.731499352885785e-02 5.728167930355290e-02 5.724837597248197e-02 5.721508355272830e-02 + 5.718180206137512e-02 5.714853151550570e-02 5.711527193220325e-02 5.708202332855103e-02 5.704878572163228e-02 + 5.701555912853024e-02 5.698234356632816e-02 5.694913905210926e-02 5.691594560295680e-02 5.688276323595402e-02 + 5.684959196818416e-02 5.681643181673045e-02 5.678328279867616e-02 5.675014493110452e-02 5.671701823109875e-02 + 5.668390271574211e-02 5.665079840211785e-02 5.661770530730920e-02 5.658462344839940e-02 5.655155284247171e-02 + 5.651849350660935e-02 5.648544545789557e-02 5.645240871341362e-02 5.641938329024674e-02 5.638636920547815e-02 + 5.635336647619112e-02 5.632037511946889e-02 5.628739515239468e-02 5.625442659205174e-02 5.622146945552333e-02 + 5.618852375989267e-02 5.615558952224302e-02 5.612266675965761e-02 5.608975548921968e-02 5.605685572801247e-02 + 5.602396749311925e-02 5.599109080162322e-02 5.595822567060765e-02 5.592537211715578e-02 5.589253015835084e-02 + 5.585969981127608e-02 5.582688109301474e-02 5.579407402065006e-02 5.576127861126528e-02 5.572849488194366e-02 + 5.569572284976842e-02 5.566296253182280e-02 5.563021394519008e-02 5.559747710695345e-02 5.556475203419618e-02 + 5.553203874400151e-02 5.549933725345269e-02 5.546664757963294e-02 5.543396973962551e-02 5.540130375051366e-02 + 5.536864962938060e-02 5.533600739330961e-02 5.530337705938389e-02 5.527075864468672e-02 5.523815216630132e-02 + 5.520555764131094e-02 5.517297508679882e-02 5.514040451984819e-02 5.510784595754230e-02 5.507529941696442e-02 + 5.504276491519774e-02 5.501024246932555e-02 5.497773209643106e-02 5.494523381359754e-02 5.491274763790820e-02 + 5.488027358644629e-02 5.484781167629507e-02 5.481536192453777e-02 5.478292434825763e-02 5.475049896453790e-02 + 5.471808579046181e-02 5.468568484311261e-02 5.465329613957354e-02 5.462091969692785e-02 5.458855553225877e-02 + 5.455620366264955e-02 5.452386410518342e-02 5.449153687694363e-02 5.445922199501343e-02 5.442691947647604e-02 + 5.439462933841474e-02 5.436235159791274e-02 5.433008627205328e-02 5.429783337791962e-02 5.426559293259499e-02 + 5.423336495316264e-02 5.420114945670580e-02 5.416894646030773e-02 5.413675598105167e-02 5.410457803602083e-02 + 5.407241264229849e-02 5.404025981696787e-02 5.400811957711223e-02 5.397599193981480e-02 5.394387692215881e-02 + 5.391177454122753e-02 5.387968481410418e-02 5.384760775787202e-02 5.381554338961427e-02 5.378349172641418e-02 + 5.375145278535501e-02 5.371942658351998e-02 5.368741313799234e-02 5.365541246585533e-02 5.362342458419220e-02 + 5.359144951008617e-02 5.355948726062051e-02 5.352753785287844e-02 5.349560130394321e-02 5.346367763089808e-02 + 5.343176685082626e-02 5.339986898081100e-02 5.336798403793557e-02 5.333611203928318e-02 5.330425300193709e-02 + 5.327240694298052e-02 5.324057387949673e-02 5.320875382856897e-02 5.317694680728046e-02 5.314515283271445e-02 + 5.311337192195419e-02 5.308160409208292e-02 5.304984936018387e-02 5.301810774334029e-02 5.298637925860694e-02 + 5.295466392210174e-02 5.292296174881576e-02 5.289127275367324e-02 5.285959695159842e-02 5.282793435751552e-02 + 5.279628498634878e-02 5.276464885302243e-02 5.273302597246069e-02 5.270141635958780e-02 5.266982002932800e-02 + 5.263823699660550e-02 5.260666727634453e-02 5.257511088346935e-02 5.254356783290417e-02 5.251203813957321e-02 + 5.248052181840073e-02 5.244901888431094e-02 5.241752935222807e-02 5.238605323707637e-02 5.235459055378005e-02 + 5.232314131726334e-02 5.229170554245050e-02 5.226028324426572e-02 5.222887443763326e-02 5.219747913747734e-02 + 5.216609735872220e-02 5.213472911629205e-02 5.210337442511115e-02 5.207203330010370e-02 5.204070575619395e-02 + 5.200939180830615e-02 5.197809147136448e-02 5.194680476029321e-02 5.191553169001656e-02 5.188427227545876e-02 + 5.185302653154403e-02 5.182179447319664e-02 5.179057611534077e-02 5.175937147290068e-02 5.172818056080060e-02 + 5.169700339396475e-02 5.166583998731737e-02 5.163469035578269e-02 5.160355451428494e-02 5.157243247774834e-02 + 5.154132426109714e-02 5.151022987925555e-02 5.147914934714782e-02 5.144808267969817e-02 5.141702989183084e-02 + 5.138599099847005e-02 5.135496601454004e-02 5.132395495496503e-02 5.129295783466926e-02 5.126197466857695e-02 + 5.123100547161235e-02 5.120005025869967e-02 5.116910904476317e-02 5.113818184472704e-02 5.110726867351554e-02 + 5.107636954605289e-02 5.104548447726333e-02 5.101461348207109e-02 5.098375657540039e-02 5.095291377217546e-02 + 5.092208508732055e-02 5.089127053575987e-02 5.086047013241765e-02 5.082968389221815e-02 5.079891183008556e-02 + 5.076815396094415e-02 5.073741029971812e-02 5.070668086133172e-02 5.067596566070917e-02 5.064526471277472e-02 + 5.061457803245257e-02 5.058390563466697e-02 5.055324753434216e-02 5.052260374640234e-02 5.049197428577178e-02 + 5.046135916737467e-02 5.043075840613528e-02 5.040017201697781e-02 5.036960001482652e-02 5.033904241460560e-02 + 5.030849923123931e-02 5.027797047965189e-02 5.024745617476754e-02 5.021695633151052e-02 5.018647096480505e-02 + 5.015600008957535e-02 5.012554372074565e-02 5.009510187324022e-02 5.006467456198324e-02 5.003426180189897e-02 + 5.000386360791163e-02 4.997347999494546e-02 4.994311097792468e-02 4.991275657177353e-02 4.988241679141623e-02 + 4.985209165177702e-02 4.982178116778014e-02 4.979148535434980e-02 4.976120422641023e-02 4.973093779888569e-02 + 4.970068608670038e-02 4.967044910477855e-02 4.964022686804442e-02 4.961001939142222e-02 4.957982668983620e-02 + 4.954964877821057e-02 4.951948567146956e-02 4.948933738453741e-02 4.945920393233836e-02 4.942908532979662e-02 + 4.939898159183643e-02 4.936889273338203e-02 4.933881876935763e-02 4.930875971468749e-02 4.927871558429582e-02 + 4.924868639310685e-02 4.921867215604481e-02 4.918867288803395e-02 4.915868860399848e-02 4.912871931886263e-02 + 4.909876504755066e-02 4.906882580498677e-02 4.903890160609520e-02 4.900899246580018e-02 4.897909839902595e-02 + 4.894921942069672e-02 4.891935554573676e-02 4.888950678907025e-02 4.885967316562146e-02 4.882985469031461e-02 + 4.880005137807392e-02 4.877026324382362e-02 4.874049030248797e-02 4.871073256899117e-02 4.868099005825745e-02 + 4.865126278521108e-02 4.862155076477624e-02 4.859185401187720e-02 4.856217254143816e-02 4.853250636838338e-02 + 4.850285550763707e-02 4.847321997412347e-02 4.844359978276680e-02 4.841399494849130e-02 4.838440548622121e-02 + 4.835483141088075e-02 4.832527273739414e-02 4.829572948068564e-02 4.826620165567946e-02 4.823668927729983e-02 + 4.820719236047098e-02 4.817771092011715e-02 4.814824497116257e-02 4.811879452853147e-02 4.808935960714807e-02 + 4.805994022193662e-02 4.803053638782134e-02 4.800114811972645e-02 4.797177543257621e-02 4.794241834129482e-02 + 4.791307686080653e-02 4.788375100603556e-02 4.785444079190614e-02 4.782514623334252e-02 4.779586734526891e-02 + 4.776660414260955e-02 4.773735664028868e-02 4.770812485323050e-02 4.767890879635927e-02 4.764970848459921e-02 + 4.762052393287456e-02 4.759135515610954e-02 4.756220216922838e-02 4.753306498715533e-02 4.750394362481459e-02 + 4.747483809713041e-02 4.744574841902701e-02 4.741667460542864e-02 4.738761667125952e-02 4.735857463144388e-02 + 4.732954850090595e-02 4.730053829456995e-02 4.727154402736015e-02 4.724256571420073e-02 4.721360337001596e-02 + 4.718465700973005e-02 4.715572664826723e-02 4.712681230055175e-02 4.709791398150782e-02 4.706903170605968e-02 + 4.704016548913156e-02 4.701131534564769e-02 4.698248129053231e-02 4.695366333870963e-02 4.692486150510391e-02 + 4.689607580463934e-02 4.686730625224018e-02 4.683855286283068e-02 4.680981565133503e-02 4.678109463267748e-02 + 4.675238982178226e-02 4.672370123357359e-02 4.669502888297572e-02 4.666637278491287e-02 4.663773295430927e-02 + 4.660910940608916e-02 4.658050215517676e-02 4.655191121649629e-02 4.652333660497202e-02 4.649477833552815e-02 + 4.646623642308891e-02 4.643771088257853e-02 4.640920172892127e-02 4.638070897704132e-02 4.635223264186294e-02 + 4.632377273831036e-02 4.629532928130779e-02 4.626690228577947e-02 4.623849176664965e-02 4.621009773884253e-02 + 4.618172021728237e-02 4.615335921689338e-02 4.612501475259979e-02 4.609668683932586e-02 4.606837549199577e-02 + 4.604008072553380e-02 4.601180255486416e-02 4.598354099491107e-02 4.595529606059879e-02 4.592706776685152e-02 + 4.589885612859351e-02 4.587066116074899e-02 4.584248287824218e-02 4.581432129599732e-02 4.578617642893863e-02 + 4.575804829199037e-02 4.572993690007673e-02 4.570184226812196e-02 4.567376441105030e-02 4.564570334378597e-02 + 4.561765908125320e-02 4.558963163837623e-02 4.556162103007928e-02 4.553362727128659e-02 4.550565037692238e-02 + 4.547769036191089e-02 4.544974724117636e-02 4.542182102964300e-02 4.539391174223504e-02 4.536601939387674e-02 + 4.533814399949231e-02 4.531028557400597e-02 4.528244413234197e-02 4.525461968942453e-02 4.522681226017790e-02 + 4.519902185952628e-02 4.517124850239393e-02 4.514349220370505e-02 4.511575297838390e-02 4.508803084135470e-02 + 4.506032580754168e-02 4.503263789186907e-02 4.500496710926111e-02 4.497731347464200e-02 4.494967700293602e-02 + 4.492205770906736e-02 4.489445560796028e-02 4.486687071453899e-02 4.483930304372771e-02 4.481175261045071e-02 + 4.478421942963219e-02 4.475670351619640e-02 4.472920488506756e-02 4.470172355116988e-02 4.467425952942764e-02 + 4.464681283476502e-02 4.461938348210628e-02 4.459197148637566e-02 4.456457686249737e-02 4.453719962539564e-02 + 4.450983978999472e-02 4.448249737121881e-02 4.445517238399217e-02 4.442786484323902e-02 4.440057476388359e-02 + 4.437330216085012e-02 4.434604704906282e-02 4.431880944344595e-02 4.429158935892372e-02 4.426438681042035e-02 + 4.423720181286010e-02 4.421003438116718e-02 4.418288453026584e-02 4.415575227508029e-02 4.412863763053477e-02 + 4.410154061155352e-02 4.407446123306075e-02 4.404739950998071e-02 4.402035545723762e-02 4.399332908975571e-02 + 4.396632042245923e-02 4.393932947027238e-02 4.391235624811941e-02 4.388540077092456e-02 4.385846305361203e-02 + 4.383154311110608e-02 4.380464095833093e-02 4.377775661021081e-02 4.375089008166996e-02 4.372404138763258e-02 + 4.369721054302294e-02 4.367039756276526e-02 4.364360246178376e-02 4.361682525500267e-02 4.359006595734623e-02 + 4.356332458373868e-02 4.353660114910423e-02 4.350989566836711e-02 4.348320815645158e-02 4.345653862828184e-02 + 4.342988709878214e-02 4.340325358287669e-02 4.337663809548974e-02 4.335004065154552e-02 4.332346126596825e-02 + 4.329689995368217e-02 4.327035672961151e-02 4.324383160868049e-02 4.321732460581335e-02 4.319083573593433e-02 + 4.316436501396765e-02 4.313791245483754e-02 4.311147807346823e-02 4.308506188478395e-02 4.305866390370894e-02 + 4.303228414516742e-02 4.300592262408363e-02 4.297957935538180e-02 4.295325435398616e-02 4.292694763482094e-02 + 4.290065921281035e-02 4.287438910287866e-02 4.284813731995007e-02 4.282190387894883e-02 4.279568879479917e-02 + 4.276949208242530e-02 4.274331375675147e-02 4.271715383270192e-02 4.269101232520085e-02 4.266488924917250e-02 + 4.263878461954113e-02 4.261269845123093e-02 4.258663075916616e-02 4.256058155827103e-02 4.253455086346980e-02 + 4.250853868968667e-02 4.248254505184589e-02 4.245656996487169e-02 4.243061344368828e-02 4.240467550321991e-02 + 4.237875615839081e-02 4.235285542412521e-02 4.232697331534734e-02 4.230110984698143e-02 4.227526503395169e-02 + 4.224943889118240e-02 4.222363143359775e-02 4.219784267612198e-02 4.217207263367933e-02 4.214632132119402e-02 + 4.212058875359029e-02 4.209487494579236e-02 4.206917991272448e-02 4.204350366931086e-02 4.201784623047573e-02 + 4.199220761114335e-02 4.196658782623791e-02 4.194098689068368e-02 4.191540481940486e-02 4.188984162732570e-02 + 4.186429732937041e-02 4.183877194046326e-02 4.181326547552844e-02 4.178777794949019e-02 4.176230937727277e-02 + 4.173685977380037e-02 4.171142915399725e-02 4.168601753278764e-02 4.166062492509574e-02 4.163525134584580e-02 + 4.160989680996207e-02 4.158456133236876e-02 4.155924492799010e-02 4.153394761175032e-02 4.150866939857367e-02 + 4.148341030338436e-02 4.145817034110662e-02 4.143294952666470e-02 4.140774787498282e-02 4.138256540098521e-02 + 4.135740211959609e-02 4.133225804573972e-02 4.130713319434030e-02 4.128202758032209e-02 4.125694121860929e-02 + 4.123187412412615e-02 4.120682631179690e-02 4.118179779654577e-02 4.115678859329698e-02 4.113179871697477e-02 + 4.110682818250337e-02 4.108187700480702e-02 4.105694519880994e-02 4.103203277943635e-02 4.100713976161051e-02 + 4.098226616025662e-02 4.095741199029894e-02 4.093257726666168e-02 4.090776200426908e-02 4.088296621804536e-02 + 4.085818992291476e-02 4.083343313380151e-02 4.080869586562985e-02 4.078397813332400e-02 4.075927995180818e-02 + 4.073460133600665e-02 4.070994230084361e-02 4.068530286124331e-02 4.066068303212998e-02 4.063608282842784e-02 + 4.061150226506113e-02 4.058694135695408e-02 4.056240011903092e-02 4.053787856621588e-02 4.051337671343318e-02 + 4.048889457560707e-02 4.046443216766178e-02 4.043998950452153e-02 4.041556660111054e-02 4.039116347235307e-02 + 4.036678013317334e-02 4.034241659849556e-02 4.031807288324400e-02 4.029374900234285e-02 4.026944497071637e-02 + 4.024516080328877e-02 4.022089651498431e-02 4.019665212072718e-02 4.017242763544165e-02 4.014822307405193e-02 + 4.012403845148225e-02 4.009987378265685e-02 4.007572908249996e-02 4.005160436593580e-02 4.002749964788860e-02 + 4.000341494328261e-02 3.997935026862905e-02 3.995530565020248e-02 3.993128111798760e-02 3.990727670197625e-02 + 3.988329243216027e-02 3.985932833853151e-02 3.983538445108181e-02 3.981146079980302e-02 3.978755741468697e-02 + 3.976367432572553e-02 3.973981156291052e-02 3.971596915623379e-02 3.969214713568721e-02 3.966834553126258e-02 + 3.964456437295178e-02 3.962080369074663e-02 3.959706351463900e-02 3.957334387462071e-02 3.954964480068362e-02 + 3.952596632281957e-02 3.950230847102040e-02 3.947867127527795e-02 3.945505476558409e-02 3.943145897193063e-02 + 3.940788392430945e-02 3.938432965271236e-02 3.936079618713123e-02 3.933728355755788e-02 3.931379179398419e-02 + 3.929032092640197e-02 3.926687098480308e-02 3.924344199917935e-02 3.922003399952266e-02 3.919664701582481e-02 + 3.917328107807769e-02 3.914993621627309e-02 3.912661246040292e-02 3.910330984045896e-02 3.908002838643308e-02 + 3.905676812831715e-02 3.903352909610298e-02 3.901031131978242e-02 3.898711482934733e-02 3.896393965478955e-02 + 3.894078582610091e-02 3.891765337327326e-02 3.889454232629846e-02 3.887145271516833e-02 3.884838456987474e-02 + 3.882533792040951e-02 3.880231279676451e-02 3.877930922893155e-02 3.875632724690252e-02 3.873336688066923e-02 + 3.871042816022353e-02 3.868751111555727e-02 3.866461577666229e-02 3.864174217353044e-02 3.861889033615356e-02 + 3.859606029452349e-02 3.857325207863209e-02 3.855046571847119e-02 3.852770124403264e-02 3.850495868530828e-02 + 3.848223807228996e-02 3.845953943496952e-02 3.843686280333881e-02 3.841420820738967e-02 3.839157567711395e-02 + 3.836896524250349e-02 3.834637693355013e-02 3.832381078024572e-02 3.830126681258209e-02 3.827874506055112e-02 + 3.825624555414461e-02 3.823376832335444e-02 3.821131339817244e-02 3.818888080859045e-02 3.816647058460032e-02 + 3.814408275619389e-02 3.812171735336303e-02 3.809937440609954e-02 3.807705394439530e-02 3.805475599824214e-02 + 3.803248059763190e-02 3.801022777255643e-02 3.798799755300758e-02 3.796578996897719e-02 3.794360505045710e-02 + 3.792144282743916e-02 3.789930332991522e-02 3.787718658787710e-02 3.785509263131667e-02 3.783302149022577e-02 + 3.781097319459624e-02 3.778894777441992e-02 3.776694525968866e-02 3.774496568039430e-02 3.772300906652870e-02 + 3.770107544808367e-02 3.767916485505110e-02 3.765727731742280e-02 3.763541286519063e-02 3.761357152834642e-02 + 3.759175333688204e-02 3.756995832078931e-02 3.754818651006007e-02 3.752643793468620e-02 3.750471262465951e-02 + 3.748301060997186e-02 3.746133192061509e-02 3.743967658658105e-02 3.741804463786157e-02 3.739643610444850e-02 + 3.737485101633371e-02 3.735328940350900e-02 3.733175129596625e-02 3.731023672369729e-02 3.728874571669397e-02 + 3.726727830494812e-02 3.724583451845160e-02 3.722441438719625e-02 3.720301794117391e-02 3.718164521037644e-02 + 3.716029622479566e-02 3.713897101442343e-02 3.711766960925159e-02 3.709639203927199e-02 3.707513833447647e-02 + 3.705390852485687e-02 3.703270264040504e-02 3.701152071111283e-02 3.699036276697207e-02 3.696922883797462e-02 + 3.694811895411231e-02 3.692703314537699e-02 3.690597144176051e-02 3.688493387325471e-02 3.686392046985143e-02 + 3.684293126154253e-02 3.682196627831984e-02 3.680102555017520e-02 3.678010910710046e-02 3.675921697908748e-02 + 3.673834919612807e-02 3.671750578821411e-02 3.669668678533742e-02 3.667589221748987e-02 3.665512211466327e-02 + 3.663437650684950e-02 3.661365542404037e-02 3.659295889622776e-02 3.657228695340348e-02 3.655163962555941e-02 + 3.653101694268735e-02 3.651041893477919e-02 3.648984563182674e-02 3.646929706382188e-02 3.644877326075641e-02 + 3.642827425262220e-02 3.640780006941109e-02 3.638735074111494e-02 3.636692629772557e-02 3.634652676923484e-02 + 3.632615218563458e-02 3.630580257691665e-02 3.628547797307289e-02 3.626517840409513e-02 3.624490389997524e-02 + 3.622465449070505e-02 3.620443020627639e-02 3.618423107668113e-02 3.616405713191111e-02 3.614390840195816e-02 + 3.612378491681414e-02 3.610368670647089e-02 3.608361380092025e-02 3.606356623015406e-02 3.604354402416417e-02 + 3.602354721294244e-02 3.600357582648069e-02 3.598362989477077e-02 3.596370944780453e-02 3.594381451557382e-02 + 3.592394512807047e-02 3.590410131528634e-02 3.588428310721326e-02 3.586449053384308e-02 3.584472362516764e-02 + 3.582498241117880e-02 3.580526692186839e-02 3.578557718722826e-02 3.576591323725024e-02 3.574627510192620e-02 + 3.572666281124797e-02 3.570707639520740e-02 3.568751588379632e-02 3.566798130700659e-02 3.564847269483005e-02 + 3.562899007725854e-02 3.560953348428391e-02 3.559010294589800e-02 3.557069849209266e-02 3.555132015285974e-02 + 3.553196795819106e-02 3.551264193807849e-02 3.549334212251386e-02 3.547406854148901e-02 3.545482122499580e-02 + 3.543560020302607e-02 3.541640550557167e-02 3.539723716262443e-02 3.537809520417620e-02 3.535897966021882e-02 + 3.533989056074414e-02 3.532082793574401e-02 3.530179181521027e-02 3.528278222913475e-02 3.526379920750932e-02 + 3.524484278032580e-02 3.522591297757607e-02 3.520700982925193e-02 3.518813336534525e-02 3.516928361584787e-02 + 3.515046061075164e-02 3.513166438004838e-02 3.511289495372998e-02 3.509415236178823e-02 3.507543663421501e-02 + 3.505674780100216e-02 3.503808589214152e-02 3.501945093762493e-02 3.500084296744425e-02 3.498226201159130e-02 + 3.496370810005795e-02 3.494518126283602e-02 3.492668152991737e-02 3.490820893129385e-02 3.488976349695729e-02 + 3.487134525689954e-02 3.485295424111245e-02 3.483459047958785e-02 3.481625400231760e-02 3.479794483929353e-02 + 3.477966302050750e-02 3.476140857595134e-02 3.474318153561690e-02 3.472498192949603e-02 3.470680978758058e-02 + 3.468866513986237e-02 3.467054801633326e-02 3.465245844698509e-02 3.463439646180971e-02 3.461636209079897e-02 + 3.459835536394470e-02 3.458037631123875e-02 3.456242496267296e-02 3.454450134823919e-02 3.452660549792927e-02 + 3.450873744173504e-02 3.449089720964835e-02 3.447308483166107e-02 3.445530033776500e-02 3.443754375795202e-02 + 3.441981512221395e-02 3.440211446054266e-02 3.438444180292995e-02 3.436679717936773e-02 3.434918061984778e-02 + 3.433159215436199e-02 3.431403181290218e-02 3.429649962546020e-02 3.427899562202789e-02 3.426151983259711e-02 + 3.424407228715969e-02 3.422665301570748e-02 3.420926204823232e-02 3.419189941472606e-02 3.417456514518054e-02 + 3.415725926958761e-02 3.413998181793911e-02 3.412273282022688e-02 3.410551230644278e-02 3.408832030657864e-02 + 3.407115685062630e-02 3.405402196857762e-02 3.403691569042444e-02 3.401983804615860e-02 3.400278906577194e-02 + 3.398576877925633e-02 3.396877721660357e-02 3.395181440780554e-02 3.393488038285408e-02 3.391797517174103e-02 + 3.390109880445821e-02 3.388425131099751e-02 3.386743272135074e-02 3.385064306550976e-02 3.383388237346641e-02 + 3.381715067521254e-02 3.380044800073998e-02 3.378377438004059e-02 3.376712984310620e-02 3.375051441992868e-02 + 3.373392814049984e-02 3.371737103481155e-02 3.370084313285564e-02 3.368434446462396e-02 3.366787506010836e-02 + 3.365143466564878e-02 3.363501887624541e-02 3.361862209777612e-02 3.360224500875989e-02 3.358588827878357e-02 + 3.356955147090725e-02 3.355323458431880e-02 3.353693766165054e-02 3.352066065506343e-02 3.350440352193865e-02 + 3.348816624199871e-02 3.347194881659273e-02 3.345575121630599e-02 3.343957340404732e-02 3.342341535303144e-02 + 3.340727704441876e-02 3.339115845430404e-02 3.337505954322636e-02 3.335898029706669e-02 3.334292070921326e-02 + 3.332688074834195e-02 3.331086037969291e-02 3.329485957414917e-02 3.327887831864652e-02 3.326291658484171e-02 + 3.324697433542376e-02 3.323105156623186e-02 3.321514826023114e-02 3.319926437839098e-02 3.318339989412266e-02 + 3.316755478754796e-02 3.315172903929034e-02 3.313592261295018e-02 3.312013548124740e-02 3.310436764153749e-02 + 3.308861906981869e-02 3.307288973180764e-02 3.305717959801665e-02 3.304148865245999e-02 3.302581687574703e-02 + 3.301016422142487e-02 3.299453067800234e-02 3.297891624809741e-02 3.296332088425066e-02 3.294774455685354e-02 + 3.293218725810471e-02 3.291664896225673e-02 3.290112963401578e-02 3.288562923879117e-02 3.287014777263271e-02 + 3.285468522369568e-02 3.283924155670871e-02 3.282381674440858e-02 3.280841076589561e-02 3.279302360243119e-02 + 3.277765521941309e-02 3.276230558706894e-02 3.274697470113698e-02 3.273166254219040e-02 3.271636907936865e-02 + 3.270109428250347e-02 3.268583813280482e-02 3.267060061307020e-02 3.265538168459424e-02 3.264018132671115e-02 + 3.262499953449712e-02 3.260983628233858e-02 3.259469153939318e-02 3.257956527754512e-02 3.256445748091834e-02 + 3.254936812698490e-02 3.253429718174427e-02 3.251924463148387e-02 3.250421046229880e-02 3.248919464552218e-02 + 3.247419715298105e-02 3.245921796288541e-02 3.244425706251369e-02 3.242931441545717e-02 3.241438998652282e-02 + 3.239948378141620e-02 3.238459577882156e-02 3.236972593925531e-02 3.235487424670715e-02 3.234004068301546e-02 + 3.232522522137563e-02 3.231042782696456e-02 3.229564848261764e-02 3.228088718700101e-02 3.226614390644563e-02 + 3.225141860917057e-02 3.223671128042128e-02 3.222202190260593e-02 3.220735044835789e-02 3.219269687989033e-02 + 3.217806118663362e-02 3.216344336205739e-02 3.214884337811092e-02 3.213426120193776e-02 3.211969680852602e-02 + 3.210515019435922e-02 3.209062132655478e-02 3.207611016186721e-02 3.206161670288540e-02 3.204714093648681e-02 + 3.203268282961075e-02 3.201824236239234e-02 3.200381951210604e-02 3.198941424912934e-02 3.197502654604618e-02 + 3.196065638811887e-02 3.194630377248257e-02 3.193196866763873e-02 3.191765104079724e-02 3.190335087680102e-02 + 3.188906815766901e-02 3.187480285784819e-02 3.186055494296534e-02 3.184632440204734e-02 3.183211122836238e-02 + 3.181791538780577e-02 3.180373685568510e-02 3.178957561657719e-02 3.177543165075891e-02 3.176130492904844e-02 + 3.174719542079285e-02 3.173310312097031e-02 3.171902801589959e-02 3.170497007535993e-02 3.169092927256592e-02 + 3.167690558660036e-02 3.166289900092451e-02 3.164890948767075e-02 3.163493702375719e-02 3.162098160094597e-02 + 3.160704320149037e-02 3.159312179836957e-02 3.157921735868882e-02 3.156532987076624e-02 3.155145932224658e-02 + 3.153760566663864e-02 3.152376889172848e-02 3.150994900180672e-02 3.149614595827410e-02 3.148235973399625e-02 + 3.146859031868535e-02 3.145483769408502e-02 3.144110182886523e-02 3.142738268687409e-02 3.141368026942635e-02 + 3.139999456778463e-02 3.138632554513814e-02 3.137267318073906e-02 3.135903745883740e-02 3.134541835839263e-02 + 3.133181584694165e-02 3.131822989974722e-02 3.130466051752389e-02 3.129110768114365e-02 3.127757136018487e-02 + 3.126405153214003e-02 3.125054818119363e-02 3.123706128835145e-02 3.122359081277034e-02 3.121013674152311e-02 + 3.119669908223311e-02 3.118327780512727e-02 3.116987287740892e-02 3.115648427590923e-02 3.114311198755302e-02 + 3.112975599208620e-02 3.111641625878769e-02 3.110309278026453e-02 3.108978554429882e-02 3.107649451605467e-02 + 3.106321967573116e-02 3.104996101093369e-02 3.103671850522385e-02 3.102349212552239e-02 3.101028184118182e-02 + 3.099708765215899e-02 3.098390954305432e-02 3.097074748653887e-02 3.095760146577434e-02 3.094447145973171e-02 + 3.093135744175442e-02 3.091825938652267e-02 3.090517727892404e-02 3.089211111199125e-02 3.087906086415095e-02 + 3.086602651045607e-02 3.085300802884278e-02 3.084000540267990e-02 3.082701861024971e-02 3.081404762072755e-02 + 3.080109242772720e-02 3.078815302348911e-02 3.077522937271052e-02 3.076232145526043e-02 3.074942925853004e-02 + 3.073655275969265e-02 3.072369193358731e-02 3.071084675893487e-02 3.069801722815575e-02 3.068520332655950e-02 + 3.067240502926292e-02 3.065962230727411e-02 3.064685514336771e-02 3.063410352936318e-02 3.062136743092317e-02 + 3.060864682743443e-02 3.059594172387181e-02 3.058325209340110e-02 3.057057790484611e-02 3.055791914232513e-02 + 3.054527578866520e-02 3.053264782274670e-02 3.052003521936738e-02 3.050743796632342e-02 3.049485605420712e-02 + 3.048228945948342e-02 3.046973815764381e-02 3.045720212753895e-02 3.044468135532321e-02 3.043217582076147e-02 + 3.041968549967531e-02 3.040721038082923e-02 3.039475044749309e-02 3.038230567464306e-02 3.036987604544383e-02 + 3.035746154526919e-02 3.034506215632694e-02 3.033267784558463e-02 3.032030859116679e-02 3.030795439680851e-02 + 3.029561524020229e-02 3.028329109283977e-02 3.027098194217670e-02 3.025868776986960e-02 3.024640855125834e-02 + 3.023414425922958e-02 3.022189488753165e-02 3.020966043396606e-02 3.019744085927903e-02 3.018523614254973e-02 + 3.017304628070488e-02 3.016087124712451e-02 3.014871101490015e-02 3.013656556629268e-02 3.012443489643160e-02 + 3.011231899192166e-02 3.010021782348693e-02 3.008813136953290e-02 3.007605961443153e-02 3.006400254477032e-02 + 3.005196013216448e-02 3.003993235442936e-02 3.002791921520012e-02 3.001592069144608e-02 3.000393675083135e-02 + 2.999196738372897e-02 2.998001257673401e-02 2.996807230790781e-02 2.995614654679549e-02 2.994423528130847e-02 + 2.993233851118915e-02 2.992045620999083e-02 2.990858835120550e-02 2.989673491731453e-02 2.988489589805536e-02 + 2.987307127537464e-02 2.986126102011340e-02 2.984946511909828e-02 2.983768356331996e-02 2.982591633787642e-02 + 2.981416341477938e-02 2.980242477098497e-02 2.979070040412034e-02 2.977899028736241e-02 2.976729439085326e-02 + 2.975561271768286e-02 2.974394525020974e-02 2.973229195799546e-02 2.972065283153817e-02 2.970902785474345e-02 + 2.969741700233630e-02 2.968582025251779e-02 2.967423759388233e-02 2.966266902120933e-02 2.965111450751603e-02 + 2.963957402972690e-02 2.962804757853395e-02 2.961653513685447e-02 2.960503668212408e-02 2.959355219023237e-02 + 2.958208165129883e-02 2.957062505724755e-02 2.955918238857859e-02 2.954775362079399e-02 2.953633873283637e-02 + 2.952493771681483e-02 2.951355054848872e-02 2.950217720053436e-02 2.949081767862442e-02 2.947947196700992e-02 + 2.946814003034778e-02 2.945682185755054e-02 2.944551743582863e-02 2.943422674341014e-02 2.942294975870480e-02 + 2.941168646812421e-02 2.940043686618776e-02 2.938920093147064e-02 2.937797864134186e-02 2.936676998172867e-02 + 2.935557493479196e-02 2.934439347979633e-02 2.933322559583284e-02 2.932207127373048e-02 2.931093050463312e-02 + 2.929980326285230e-02 2.928868953142686e-02 2.927758929945683e-02 2.926650254799867e-02 2.925542925398767e-02 + 2.924436939550082e-02 2.923332296415483e-02 2.922228995044700e-02 2.921127033783603e-02 2.920026410004271e-02 + 2.918927122033416e-02 2.917829169471517e-02 2.916732549176795e-02 2.915637258777840e-02 2.914543298801943e-02 + 2.913450667577263e-02 2.912359362430894e-02 2.911269381274288e-02 2.910180723305731e-02 2.909093387402745e-02 + 2.908007369930849e-02 2.906922669822638e-02 2.905839287303405e-02 2.904757219714476e-02 2.903676465199738e-02 + 2.902597022808873e-02 2.901518890157972e-02 2.900442065055892e-02 2.899366546087253e-02 2.898292332562971e-02 + 2.897219423070421e-02 2.896147815085827e-02 2.895077507160809e-02 2.894008498122344e-02 2.892940786384609e-02 + 2.891874369517828e-02 2.890809245634708e-02 2.889745414621765e-02 2.888682874769054e-02 2.887621623583590e-02 + 2.886561659425123e-02 2.885502981116054e-02 2.884445587294774e-02 2.883389475319686e-02 2.882334643970105e-02 + 2.881281093000496e-02 2.880228819979298e-02 2.879177822929067e-02 2.878128100842524e-02 2.877079651898801e-02 + 2.876032473884395e-02 2.874986564740009e-02 2.873941924390505e-02 2.872898552052601e-02 2.871856444638324e-02 + 2.870815600507148e-02 2.869776018641480e-02 2.868737697516582e-02 2.867700634591397e-02 2.866664827916806e-02 + 2.865630278319325e-02 2.864596983917359e-02 2.863564941328856e-02 2.862534149829953e-02 2.861504608429113e-02 + 2.860476315234840e-02 2.859449267740666e-02 2.858423464566411e-02 2.857398905422620e-02 2.856375588402207e-02 + 2.855353511594846e-02 2.854332673804624e-02 2.853313073796621e-02 2.852294709429606e-02 2.851277577543872e-02 + 2.850261678440491e-02 2.849247012219593e-02 2.848233575178603e-02 2.847221365657614e-02 2.846210383116990e-02 + 2.845200625935100e-02 2.844192091752946e-02 2.843184778466237e-02 2.842178686053369e-02 2.841173813547823e-02 + 2.840170158739025e-02 2.839167719418843e-02 2.838166494245600e-02 2.837166482484053e-02 2.836167681707307e-02 + 2.835170090137019e-02 2.834173707461769e-02 2.833178532393912e-02 2.832184563033358e-02 2.831191797277370e-02 + 2.830200233825938e-02 2.829209871310940e-02 2.828220707523810e-02 2.827232741579271e-02 2.826245972853687e-02 + 2.825260399229306e-02 2.824276019064247e-02 2.823292831178126e-02 2.822310834132040e-02 2.821330025651807e-02 + 2.820350403438503e-02 2.819371967866794e-02 2.818394718049788e-02 2.817418651237375e-02 2.816443766090156e-02 + 2.815470061416237e-02 2.814497535504664e-02 2.813526186206681e-02 2.812556012131105e-02 2.811587013236315e-02 + 2.810619188120791e-02 2.809652534562629e-02 2.808687050311100e-02 2.807722734684383e-02 2.806759586949595e-02 + 2.805797603975531e-02 2.804836784541272e-02 2.803877128655403e-02 2.802918634812817e-02 2.801961300908425e-02 + 2.801005124931340e-02 2.800050106254358e-02 2.799096243185147e-02 2.798143533065562e-02 2.797191976200169e-02 + 2.796241571829330e-02 2.795292316767612e-02 2.794344209750147e-02 2.793397250080147e-02 2.792451436474921e-02 + 2.791506766429417e-02 2.790563238187514e-02 2.789620852426368e-02 2.788679607109519e-02 2.787739499448651e-02 + 2.786800529276515e-02 2.785862695250820e-02 2.784925995023579e-02 2.783990426851568e-02 2.783055990112446e-02 + 2.782122684523413e-02 2.781190507602721e-02 2.780259457625915e-02 2.779329533996523e-02 2.778400734510273e-02 + 2.777473057425486e-02 2.776546502209671e-02 2.775621067523501e-02 2.774696751775778e-02 2.773773553529171e-02 + 2.772851471226555e-02 2.771930503638066e-02 2.771010650156085e-02 2.770091908311444e-02 2.769174275675288e-02 + 2.768257752750487e-02 2.767342338343482e-02 2.766428030170250e-02 2.765514827509389e-02 2.764602728937508e-02 + 2.763691732224667e-02 2.762781835629091e-02 2.761873038318760e-02 2.760965340016332e-02 2.760058738918467e-02 + 2.759153233095657e-02 2.758248821223181e-02 2.757345502668101e-02 2.756443275844788e-02 2.755542137569210e-02 + 2.754642087861812e-02 2.753743126859248e-02 2.752845251726651e-02 2.751948461051369e-02 2.751052754088128e-02 + 2.750158129051000e-02 2.749264584112846e-02 2.748372117908398e-02 2.747480730190011e-02 2.746590419839729e-02 + 2.745701184777745e-02 2.744813023052759e-02 2.743925933666562e-02 2.743039916197098e-02 2.742154968107790e-02 + 2.741271087850060e-02 2.740388275814067e-02 2.739506530469222e-02 2.738625849608251e-02 2.737746231424592e-02 + 2.736867675514432e-02 2.735990180809817e-02 2.735113743878892e-02 2.734238364845174e-02 2.733364044336462e-02 + 2.732490778587926e-02 2.731618566204183e-02 2.730747407386686e-02 2.729877300249025e-02 2.729008242908668e-02 + 2.728140234030172e-02 2.727273272900814e-02 2.726407358354408e-02 2.725542488697956e-02 2.724678662927163e-02 + 2.723815879907967e-02 2.722954137935252e-02 2.722093434732608e-02 2.721233769152850e-02 2.720375141931018e-02 + 2.719517551218435e-02 2.718660994644712e-02 2.717805471481514e-02 2.716950980584153e-02 2.716097520393317e-02 + 2.715245089289530e-02 2.714393686286031e-02 2.713543310581999e-02 2.712693960497614e-02 2.711845634782483e-02 + 2.710998332519429e-02 2.710152051958041e-02 2.709306791441093e-02 2.708462549834906e-02 2.707619326918369e-02 + 2.706777121480425e-02 2.705935930907671e-02 2.705095754483260e-02 2.704256591454058e-02 2.703418439795306e-02 + 2.702581298145425e-02 2.701745165546447e-02 2.700910041075726e-02 2.700075923746808e-02 2.699242812272907e-02 + 2.698410704764140e-02 2.697579599978723e-02 2.696749496984126e-02 2.695920394125775e-02 2.695092290187428e-02 + 2.694265184396634e-02 2.693439075649869e-02 2.692613962541774e-02 2.691789843589869e-02 2.690966718080280e-02 + 2.690144584430361e-02 2.689323440003169e-02 2.688503284907665e-02 2.687684119009101e-02 2.686865940030225e-02 + 2.686048746353486e-02 2.685232536881714e-02 2.684417310662326e-02 2.683603066151065e-02 2.682789801897943e-02 + 2.681977517552054e-02 2.681166212021913e-02 2.680355883616239e-02 2.679546530889016e-02 2.678738152752996e-02 + 2.677930748200765e-02 2.677124315479004e-02 2.676318853591112e-02 2.675514362231527e-02 2.674710839396962e-02 + 2.673908283555094e-02 2.673106694339361e-02 2.672306070150655e-02 2.671506409151823e-02 2.670707710108217e-02 + 2.669909972943648e-02 2.669113197027321e-02 2.668317379682501e-02 2.667522519875436e-02 2.666728617090520e-02 + 2.665935669311371e-02 2.665143675159882e-02 2.664352634032146e-02 2.663562545659268e-02 2.662773408361464e-02 + 2.661985219717407e-02 2.661197979572226e-02 2.660411687169956e-02 2.659626340488144e-02 2.658841937631547e-02 + 2.658058477937751e-02 2.657275961893512e-02 2.656494387358596e-02 2.655713752275513e-02 2.654934056348008e-02 + 2.654155298332925e-02 2.653377476657220e-02 2.652600590198415e-02 2.651824638075199e-02 2.651049619255404e-02 + 2.650275532091429e-02 2.649502375487615e-02 2.648730148802552e-02 2.647958851263073e-02 2.647188480891689e-02 + 2.646419035368700e-02 2.645650515131691e-02 2.644882919484906e-02 2.644116246069965e-02 2.643350494181170e-02 + 2.642585663084689e-02 2.641821751242615e-02 2.641058756892747e-02 2.640296679007395e-02 2.639535517653221e-02 + 2.638775271175803e-02 2.638015937698240e-02 2.637257516664822e-02 2.636500007332271e-02 2.635743408373907e-02 + 2.634987717633525e-02 2.634232934391862e-02 2.633479058525924e-02 2.632726088227431e-02 2.631974022390311e-02 + 2.631222860499385e-02 2.630472600717760e-02 2.629723241433261e-02 2.628974781674581e-02 2.628227220621198e-02 + 2.627480557677242e-02 2.626734792215179e-02 2.625989921852152e-02 2.625245945041883e-02 2.624502862403611e-02 + 2.623760671958282e-02 2.623019371536040e-02 2.622278961237779e-02 2.621539440295659e-02 2.620800807254220e-02 + 2.620063060674004e-02 2.619326199404739e-02 2.618590222410475e-02 2.617855128386046e-02 2.617120916522779e-02 + 2.616387586230346e-02 2.615655135861502e-02 2.614923564213544e-02 2.614192870720641e-02 2.613463054125929e-02 + 2.612734112755428e-02 2.612006044964381e-02 2.611278850871195e-02 2.610552530050819e-02 2.609827080222275e-02 + 2.609102500359168e-02 2.608378789925431e-02 2.607655947900249e-02 2.606933972466179e-02 2.606212861946312e-02 + 2.605492616097670e-02 2.604773234503024e-02 2.604054716124884e-02 2.603337058950191e-02 2.602620261873257e-02 + 2.601904324395194e-02 2.601189244598317e-02 2.600475021758196e-02 2.599761656283118e-02 2.599049145836681e-02 + 2.598337488632347e-02 2.597626684662969e-02 2.596916733159564e-02 2.596207632537513e-02 2.595499380688753e-02 + 2.594791977426907e-02 2.594085422650568e-02 2.593379714560815e-02 2.592674851872178e-02 2.591970833661526e-02 + 2.591267658830654e-02 2.590565326173340e-02 2.589863834578747e-02 2.589163183398775e-02 2.588463371701131e-02 + 2.587764398252935e-02 2.587066261956569e-02 2.586368961749470e-02 2.585672496539723e-02 2.584976865103265e-02 + 2.584282066471713e-02 2.583588100000093e-02 2.582894964599770e-02 2.582202659070586e-02 2.581511182332461e-02 + 2.580820533343631e-02 2.580130710958863e-02 2.579441713875388e-02 2.578753541579036e-02 2.578066193633965e-02 + 2.577379668579866e-02 2.576693964640701e-02 2.576009080523955e-02 2.575325016689414e-02 2.574641771694009e-02 + 2.573959342940173e-02 2.573277731100565e-02 2.572596935753856e-02 2.571916954588383e-02 2.571237786264848e-02 + 2.570559430241213e-02 2.569881886299849e-02 2.569205152414907e-02 2.568529227185872e-02 2.567854111122693e-02 + 2.567179802594942e-02 2.566506299732867e-02 2.565833602386073e-02 2.565161709921462e-02 2.564490620914589e-02 + 2.563820333139000e-02 2.563150846268354e-02 2.562482160754986e-02 2.561814274902439e-02 2.561147187258114e-02 + 2.560480896924013e-02 2.559815402833877e-02 2.559150703774291e-02 2.558486798572520e-02 2.557823686789989e-02 + 2.557161367849433e-02 2.556499840587265e-02 2.555839103232124e-02 2.555179154834854e-02 2.554519995829834e-02 + 2.553861624178350e-02 2.553204037844031e-02 2.552547237202886e-02 2.551891221538829e-02 2.551235989397021e-02 + 2.550581539575596e-02 2.549927871458803e-02 2.549274984258965e-02 2.548622875540724e-02 2.547971544999134e-02 + 2.547320993631275e-02 2.546671219025347e-02 2.546022219347805e-02 2.545373994243675e-02 2.544726542971977e-02 + 2.544079864501286e-02 2.543433957656028e-02 2.542788821576999e-02 2.542144455508066e-02 2.541500858637495e-02 + 2.540858030019949e-02 2.540215968413957e-02 2.539574672197945e-02 2.538934140646816e-02 2.538294373410821e-02 + 2.537655369660362e-02 2.537017128263758e-02 2.536379648098229e-02 2.535742928550868e-02 2.535106968465225e-02 + 2.534471766277936e-02 2.533837321084466e-02 2.533203632423742e-02 2.532570699881585e-02 2.531938521813243e-02 + 2.531307097096266e-02 2.530676425602581e-02 2.530046505932213e-02 2.529417336607690e-02 2.528788916915281e-02 + 2.528161246489754e-02 2.527534324609989e-02 2.526908149634068e-02 2.526282720495094e-02 2.525658036572961e-02 + 2.525034097275206e-02 2.524410901058027e-02 2.523788446449190e-02 2.523166734234336e-02 2.522545763237074e-02 + 2.521925530838600e-02 2.521306037097086e-02 2.520687281776321e-02 2.520069263496993e-02 2.519451980442291e-02 + 2.518835431925369e-02 2.518219618546694e-02 2.517604538654039e-02 2.516990190396150e-02 2.516376573127799e-02 + 2.515763686639562e-02 2.515151530112912e-02 2.514540101358030e-02 2.513929399756280e-02 2.513319425347670e-02 + 2.512710177240427e-02 2.512101654329324e-02 2.511493855506050e-02 2.510886779787783e-02 2.510280425830826e-02 + 2.509674792451250e-02 2.509069880343641e-02 2.508465688466923e-02 2.507862214067907e-02 2.507259457630134e-02 + 2.506657418922008e-02 2.506056095604422e-02 2.505455486579475e-02 2.504855591546334e-02 2.504256410459500e-02 + 2.503657941982099e-02 2.503060184642849e-02 2.502463137903613e-02 2.501866800626509e-02 2.501271171663477e-02 + 2.500676250820755e-02 2.500082037092928e-02 2.499488529135626e-02 2.498895726677344e-02 2.498303628979692e-02 + 2.497712234741346e-02 2.497121542814719e-02 2.496531552247531e-02 2.495942262282587e-02 2.495353672310340e-02 + 2.494765781766853e-02 2.494178589943900e-02 2.493592095223772e-02 2.493006296439117e-02 2.492421193524048e-02 + 2.491836784922406e-02 2.491253069345717e-02 2.490670047398909e-02 2.490087718065651e-02 2.489506079631419e-02 + 2.488925131370227e-02 2.488344872747560e-02 2.487765302865731e-02 2.487186419727612e-02 2.486608223223404e-02 + 2.486030714174834e-02 2.485453889875117e-02 2.484877749156952e-02 2.484302292908405e-02 2.483727519324232e-02 + 2.483153426549052e-02 2.482580013961989e-02 2.482007281919668e-02 2.481435229933991e-02 2.480863855780388e-02 + 2.480293158683973e-02 2.479723138421890e-02 2.479153794250162e-02 2.478585124573938e-02 2.478017128120043e-02 + 2.477449805440481e-02 2.476883155587847e-02 2.476317176818658e-02 2.475751868877601e-02 2.475187231076201e-02 + 2.474623262098153e-02 2.474059960704484e-02 2.473497326224523e-02 2.472935358498410e-02 2.472374056978996e-02 + 2.471813420423485e-02 2.471253447111526e-02 2.470694136984621e-02 2.470135489678424e-02 2.469577503399494e-02 + 2.469020177298829e-02 2.468463511029760e-02 2.467907504169421e-02 2.467352155791407e-02 2.466797464651026e-02 + 2.466243429488579e-02 2.465690049712254e-02 2.465137324948606e-02 2.464585254039273e-02 2.464033836402688e-02 + 2.463483071739735e-02 2.462932958374225e-02 2.462383495186045e-02 2.461834681928389e-02 2.461286517898853e-02 + 2.460739002108202e-02 2.460192133524253e-02 2.459645911917798e-02 2.459100336526309e-02 2.458555405446716e-02 + 2.458011118496141e-02 2.457467475465895e-02 2.456924474486533e-02 2.456382114921245e-02 2.455840396700115e-02 + 2.455299319041756e-02 2.454758880740113e-02 2.454219080674820e-02 2.453679918638537e-02 2.453141393576077e-02 + 2.452603503863916e-02 2.452066249180092e-02 2.451529629410615e-02 2.450993644073534e-02 2.450458291517292e-02 + 2.449923570627392e-02 2.449389481263279e-02 2.448856022075961e-02 2.448323192252920e-02 2.447790992354739e-02 + 2.447259420740984e-02 2.446728475663024e-02 2.446198157303190e-02 2.445668465268695e-02 2.445139398411770e-02 + 2.444610955000165e-02 2.444083134675017e-02 2.443555937646448e-02 2.443029362647454e-02 2.442503408583922e-02 + 2.441978074770511e-02 2.441453360513738e-02 2.440929264714783e-02 2.440405786136508e-02 2.439882924944217e-02 + 2.439360680824694e-02 2.438839052372590e-02 2.438318038826778e-02 2.437797639360750e-02 2.437277852674977e-02 + 2.436758678074824e-02 2.436240115296091e-02 2.435722164202054e-02 2.435204823529888e-02 2.434688091817521e-02 + 2.434171968740183e-02 2.433656453724402e-02 2.433141545805634e-02 2.432627243782077e-02 2.432113546933723e-02 + 2.431600455029639e-02 2.431087967900234e-02 2.430576084399959e-02 2.430064802749307e-02 2.429554123205279e-02 + 2.429044044976694e-02 2.428534565606734e-02 2.428025685952290e-02 2.427517406275088e-02 2.427009724038350e-02 + 2.426502638834353e-02 2.425996150697585e-02 2.425490258288459e-02 2.424984960255012e-02 2.424480255754471e-02 + 2.423976144931379e-02 2.423472627405213e-02 2.422969702193537e-02 2.422467367993699e-02 2.421965624107330e-02 + 2.421464470176334e-02 2.420963904926960e-02 2.420463927567678e-02 2.419964537946393e-02 2.419465735323985e-02 + 2.418967518800793e-02 2.418469887545246e-02 2.417972840901141e-02 2.417476377855392e-02 2.416980496962540e-02 + 2.416485198688481e-02 2.415990483049387e-02 2.415496347565664e-02 2.415002792020104e-02 2.414509816788697e-02 + 2.414017420064829e-02 2.413525600526027e-02 2.413034357711665e-02 2.412543691925479e-02 2.412053602209589e-02 + 2.411564086852338e-02 2.411075145960207e-02 2.410586778967854e-02 2.410098984367492e-02 2.409611761892932e-02 + 2.409125110932578e-02 2.408639030144091e-02 2.408153519631380e-02 2.407668578962185e-02 2.407184206146642e-02 + 2.406700400909483e-02 2.406217163125833e-02 2.405734491326586e-02 2.405252385052364e-02 2.404770844026444e-02 + 2.404289866819192e-02 2.403809452984102e-02 2.403329602484744e-02 2.402850314011094e-02 2.402371586479471e-02 + 2.401893419282938e-02 2.401415812045089e-02 2.400938764313821e-02 2.400462275334547e-02 2.399986343578922e-02 + 2.399510968520409e-02 2.399036150812855e-02 2.398561888480285e-02 2.398088180164008e-02 2.397615026865237e-02 + 2.397142427338870e-02 2.396670380040281e-02 2.396198885088599e-02 2.395727942113068e-02 2.395257549962209e-02 + 2.394787706723708e-02 2.394318412617158e-02 2.393849668455232e-02 2.393381472012022e-02 2.392913822141401e-02 + 2.392446719065216e-02 2.391980162598514e-02 2.391514151312970e-02 2.391048683154523e-02 2.390583758880722e-02 + 2.390119378770886e-02 2.389655541357522e-02 2.389192245255953e-02 2.388729489743550e-02 2.388267274893805e-02 + 2.387805599705324e-02 2.387344463051915e-02 2.386883864637205e-02 2.386423804212813e-02 2.385964281176755e-02 + 2.385505294183017e-02 2.385046842474073e-02 2.384588925674739e-02 2.384131543037479e-02 2.383674693675093e-02 + 2.383218376863605e-02 2.382762592698097e-02 2.382307340607612e-02 2.381852619200930e-02 2.381398427584630e-02 + 2.380944765139419e-02 2.380491631418275e-02 2.380039026147703e-02 2.379586948695320e-02 2.379135397827495e-02 + 2.378684372855616e-02 2.378233873403001e-02 2.377783899070361e-02 2.377334448688785e-02 2.376885521259772e-02 + 2.376437117173840e-02 2.375989235311110e-02 2.375541874056297e-02 2.375095033967465e-02 2.374648714507580e-02 + 2.374202914136664e-02 2.373757632537944e-02 2.373312869288914e-02 2.372868623536894e-02 2.372424894471153e-02 + 2.371981681484819e-02 2.371538984133524e-02 2.371096801501392e-02 2.370655132827953e-02 2.370213977833190e-02 + 2.369773335765337e-02 2.369333205880069e-02 2.368893587883010e-02 2.368454481046802e-02 2.368015884444250e-02 + 2.367577797334512e-02 2.367140218742613e-02 2.366703147963686e-02 2.366266585606776e-02 2.365830530976384e-02 + 2.365394982335759e-02 2.364959939168465e-02 2.364525401200215e-02 2.364091367903051e-02 2.363657837870221e-02 + 2.363224810602428e-02 2.362792286773459e-02 2.362360264929340e-02 2.361928743769403e-02 2.361497723470610e-02 + 2.361067203383207e-02 2.360637182449869e-02 2.360207659794005e-02 2.359778635431920e-02 2.359350109143980e-02 + 2.358922079027601e-02 2.358494544772182e-02 2.358067506765588e-02 2.357640963547734e-02 2.357214914179353e-02 + 2.356789358468287e-02 2.356364296127548e-02 2.355939726289868e-02 2.355515647729875e-02 2.355092060314220e-02 + 2.354668963726047e-02 2.354246356971432e-02 2.353824239065819e-02 2.353402609608870e-02 2.352981468856027e-02 + 2.352560815209497e-02 2.352140647526573e-02 2.351720967050562e-02 2.351301772305351e-02 2.350883061252196e-02 + 2.350464834642137e-02 2.350047092197861e-02 2.349629832802946e-02 2.349213055910952e-02 2.348796760574937e-02 + 2.348380945835795e-02 2.347965612326723e-02 2.347550759163322e-02 2.347136384068571e-02 2.346722487769892e-02 + 2.346309070523777e-02 2.345896130833473e-02 2.345483667635093e-02 2.345071680463291e-02 2.344660169327714e-02 + 2.344249133136094e-02 2.343838570884467e-02 2.343428482723373e-02 2.343018868068117e-02 2.342609726030811e-02 + 2.342201056195244e-02 2.341792857876926e-02 2.341385130156056e-02 2.340977872164902e-02 2.340571083589386e-02 + 2.340164764377465e-02 2.339758913684304e-02 2.339353530825718e-02 2.338948615385810e-02 2.338544166438565e-02 + 2.338140183238109e-02 2.337736665460082e-02 2.337333612670094e-02 2.336931024309368e-02 2.336528899670786e-02 + 2.336127237782067e-02 2.335726037932775e-02 2.335325300092871e-02 2.334925023614406e-02 2.334525207670920e-02 + 2.334125851951941e-02 2.333726955725296e-02 2.333328518197435e-02 2.332930539416707e-02 2.332533018620607e-02 + 2.332135954429912e-02 2.331739346348105e-02 2.331343194297124e-02 2.330947498175055e-02 2.330552256758802e-02 + 2.330157469245372e-02 2.329763135682490e-02 2.329369255310137e-02 2.328975827131819e-02 2.328582850377367e-02 + 2.328190324900185e-02 2.327798250467623e-02 2.327406626164597e-02 2.327015451465238e-02 2.326624725851670e-02 + 2.326234448228765e-02 2.325844618291867e-02 2.325455236057939e-02 2.325066300636415e-02 2.324677811186985e-02 + 2.324289767062798e-02 2.323902167622130e-02 2.323515012509116e-02 2.323128301561370e-02 2.322742034088871e-02 + 2.322356209250113e-02 2.321970826255392e-02 2.321585884544971e-02 2.321201383858435e-02 2.320817324137425e-02 + 2.320433704277431e-02 2.320050523099401e-02 2.319667780275936e-02 2.319285475700314e-02 2.318903609087885e-02 + 2.318522179577433e-02 2.318141186586264e-02 2.317760629632794e-02 2.317380507773795e-02 2.317000820301008e-02 + 2.316621566880872e-02 2.316242747510807e-02 2.315864361575457e-02 2.315486407850317e-02 2.315108885694486e-02 + 2.314731794816131e-02 2.314355135044316e-02 2.313978905662257e-02 2.313603105913640e-02 2.313227735329952e-02 + 2.312852793585061e-02 2.312478280157292e-02 2.312104194073204e-02 2.311730534704967e-02 2.311357301587891e-02 + 2.310984494137890e-02 2.310612112341407e-02 2.310240155989217e-02 2.309868623130452e-02 2.309497513592190e-02 + 2.309126828241582e-02 2.308756565023808e-02 2.308386723175103e-02 2.308017303542274e-02 2.307648304592169e-02 + 2.307279725617671e-02 2.306911567493640e-02 2.306543828441958e-02 2.306176507302976e-02 2.305809605235563e-02 + 2.305443121050249e-02 2.305077053229759e-02 2.304711401909808e-02 2.304346166830784e-02 2.303981347406350e-02 + 2.303616943085239e-02 2.303252953349069e-02 2.302889377643319e-02 2.302526215247478e-02 2.302163465435939e-02 + 2.301801127709388e-02 2.301439202296127e-02 2.301077688440331e-02 2.300716584594829e-02 2.300355891234385e-02 + 2.299995607931316e-02 2.299635732709070e-02 2.299276266087610e-02 2.298917208378683e-02 2.298558558107965e-02 + 2.298200314503575e-02 2.297842477288603e-02 2.297485046311076e-02 2.297128020911345e-02 2.296771400315858e-02 + 2.296415184168031e-02 2.296059371667762e-02 2.295703962066644e-02 2.295348955785851e-02 2.294994352217295e-02 + 2.294640149900077e-02 2.294286348264926e-02 2.293932947451599e-02 2.293579947717141e-02 2.293227347444131e-02 + 2.292875145668869e-02 2.292523342863249e-02 2.292171938675970e-02 2.291820932208030e-02 2.291470322329688e-02 + 2.291120108573121e-02 2.290770290936340e-02 2.290420869564250e-02 2.290071843254762e-02 2.289723210840996e-02 + 2.289374972996874e-02 2.289027128684278e-02 2.288679676284003e-02 2.288332616596880e-02 2.287985949623025e-02 + 2.287639674290211e-02 2.287293789614104e-02 2.286948295143698e-02 2.286603190794522e-02 2.286258475709644e-02 + 2.285914149325583e-02 2.285570211629635e-02 2.285226661817064e-02 2.284883499242224e-02 2.284540723897847e-02 + 2.284198334984975e-02 2.283856331588243e-02 2.283514713353579e-02 2.283173480111027e-02 2.282832631556901e-02 + 2.282492166909090e-02 2.282152085461623e-02 2.281812386736860e-02 2.281473070606539e-02 2.281134136558116e-02 + 2.280795583769253e-02 2.280457411713410e-02 2.280119619914733e-02 2.279782207936136e-02 2.279445175627783e-02 + 2.279108522557549e-02 2.278772247795469e-02 2.278436350274908e-02 2.278100829770330e-02 2.277765687156956e-02 + 2.277430921150676e-02 2.277096530368425e-02 2.276762515226868e-02 2.276428875675497e-02 2.276095610802096e-02 + 2.275762718728153e-02 2.275430199700514e-02 2.275098054723153e-02 2.274766282325953e-02 2.274434881806882e-02 + 2.274103853245654e-02 2.273773195657694e-02 2.273442908251650e-02 2.273112990748000e-02 2.272783443024632e-02 + 2.272454264587135e-02 2.272125454541999e-02 2.271797012768606e-02 2.271468938883630e-02 2.271141231743784e-02 + 2.270813891155475e-02 2.270486917113991e-02 2.270160309030139e-02 2.269834065991423e-02 2.269508187421201e-02 + 2.269182673791773e-02 2.268857524219826e-02 2.268532737305624e-02 2.268208313254210e-02 2.267884251722086e-02 + 2.267560551920548e-02 2.267237214108131e-02 2.266914237609957e-02 2.266591620883689e-02 2.266269364166427e-02 + 2.265947467384046e-02 2.265625929499294e-02 2.265304750285308e-02 2.264983929495161e-02 2.264663466331073e-02 + 2.264343359962570e-02 2.264023610100446e-02 2.263704217283995e-02 2.263385180078203e-02 2.263066497176033e-02 + 2.262748170200772e-02 2.262430198020481e-02 2.262112578516977e-02 2.261795313211606e-02 2.261478401664109e-02 + 2.261161841743119e-02 2.260845633522814e-02 2.260529777070043e-02 2.260214271924124e-02 2.259899117823321e-02 + 2.259584314154298e-02 2.259269859890657e-02 2.258955754741791e-02 2.258641998536936e-02 2.258328590829124e-02 + 2.258015531052365e-02 2.257702818646037e-02 2.257390453172050e-02 2.257078434461123e-02 2.256766762198980e-02 + 2.256455435398716e-02 2.256144453344060e-02 2.255833815784602e-02 2.255523523027356e-02 2.255213574452021e-02 + 2.254903968810603e-02 2.254594705829782e-02 2.254285785514665e-02 2.253977207653749e-02 2.253668970834607e-02 + 2.253361074658835e-02 2.253053520058667e-02 2.252746305460894e-02 2.252439429792020e-02 2.252132894054988e-02 + 2.251826697539277e-02 2.251520839162438e-02 2.251215318778324e-02 2.250910135797150e-02 2.250605289615611e-02 + 2.250300780314812e-02 2.249996607511807e-02 2.249692770517706e-02 2.249389268897849e-02 2.249086101912092e-02 + 2.248783268793952e-02 2.248480769791340e-02 2.248178604607573e-02 2.247876772289102e-02 2.247575272657626e-02 + 2.247274105420605e-02 2.246973269884927e-02 2.246672765673356e-02 2.246372592391256e-02 2.246072749418018e-02 + 2.245773236145919e-02 2.245474052366870e-02 2.245175198466864e-02 2.244876673416187e-02 2.244578475935081e-02 + 2.244280606154297e-02 2.243983064008646e-02 2.243685849064164e-02 2.243388960632717e-02 2.243092397966235e-02 + 2.242796160524575e-02 2.242500248562306e-02 2.242204661762487e-02 2.241909399183298e-02 2.241614460666303e-02 + 2.241319845819517e-02 2.241025553754803e-02 2.240731584245553e-02 2.240437937032112e-02 2.240144611432051e-02 + 2.239851607018801e-02 2.239558923444239e-02 2.239266560299412e-02 2.238974517661811e-02 2.238682795331298e-02 + 2.238391391839321e-02 2.238100306495051e-02 2.237809539304577e-02 2.237519090301935e-02 2.237228958954325e-02 + 2.236939144530989e-02 2.236649647337483e-02 2.236360466636645e-02 2.236071600836286e-02 2.235783050633204e-02 + 2.235494816009726e-02 2.235206895420678e-02 2.234919288912077e-02 2.234631996540050e-02 2.234345017408028e-02 + 2.234058350741709e-02 2.233771996217690e-02 2.233485954108143e-02 2.233200223848051e-02 2.232914804618978e-02 + 2.232629696222737e-02 2.232344898389008e-02 2.232060410657171e-02 2.231776232362639e-02 2.231492363175558e-02 + 2.231208802922137e-02 2.230925550831191e-02 2.230642606279709e-02 2.230359969032392e-02 2.230077639232617e-02 + 2.229795616382932e-02 2.229513899284023e-02 2.229232488215048e-02 2.228951382986107e-02 2.228670582046145e-02 + 2.228390085767177e-02 2.228109894426768e-02 2.227830006461064e-02 2.227550421765863e-02 2.227271140560883e-02 + 2.226992161633195e-02 2.226713484518715e-02 2.226435109357777e-02 2.226157036041665e-02 2.225879263594571e-02 + 2.225601790864145e-02 2.225324618600033e-02 2.225047746610503e-02 2.224771173578603e-02 2.224494899695189e-02 + 2.224218924606724e-02 2.223943246967720e-02 2.223667867147697e-02 2.223392785229840e-02 2.223117999944780e-02 + 2.222843510958861e-02 2.222569318138216e-02 2.222295420869658e-02 2.222021819230338e-02 2.221748513172378e-02 + 2.221475501403353e-02 2.221202783347761e-02 2.220930358964832e-02 2.220658227937696e-02 2.220386389978368e-02 + 2.220114844711944e-02 2.219843591216284e-02 2.219572629440826e-02 2.219301959936691e-02 2.219031581219321e-02 + 2.218761492468887e-02 2.218491694233576e-02 2.218222185562244e-02 2.217952965986671e-02 2.217684036403281e-02 + 2.217415395419634e-02 2.217147041795686e-02 2.216878976537657e-02 2.216611199005385e-02 2.216343708084910e-02 + 2.216076504044857e-02 2.215809586407636e-02 2.215542954392592e-02 2.215276608232491e-02 2.215010547339664e-02 + 2.214744770611955e-02 2.214479278225410e-02 2.214214070177000e-02 2.213949145934428e-02 2.213684504847090e-02 + 2.213420146383213e-02 2.213156070201421e-02 2.212892275987791e-02 2.212628763520102e-02 2.212365532631548e-02 + 2.212102582567219e-02 2.211839912707401e-02 2.211577523186081e-02 2.211315413883962e-02 2.211053584219323e-02 + 2.210792033053083e-02 2.210530760247808e-02 2.210269766011106e-02 2.210009049378774e-02 2.209748609987134e-02 + 2.209488448015577e-02 2.209228563063591e-02 2.208968954607055e-02 2.208709622107550e-02 2.208450564887732e-02 + 2.208191782589816e-02 2.207933275252874e-02 2.207675042560285e-02 2.207417084119970e-02 2.207159399606388e-02 + 2.206901988424427e-02 2.206644850045388e-02 2.206387984291528e-02 2.206131390816773e-02 2.205875069196218e-02 + 2.205619019101501e-02 2.205363240248722e-02 2.205107732226570e-02 2.204852494231603e-02 2.204597526222870e-02 + 2.204342828418220e-02 2.204088399409952e-02 2.203834238815479e-02 2.203580347352047e-02 2.203326724064265e-02 + 2.203073368487589e-02 2.202820281109562e-02 2.202567460568826e-02 2.202314905892956e-02 2.202062617713913e-02 + 2.201810595951965e-02 2.201558839960293e-02 2.201307348855861e-02 2.201056122699519e-02 2.200805161543166e-02 + 2.200554464185156e-02 2.200304030240887e-02 2.200053859846551e-02 2.199803952619762e-02 2.199554308107517e-02 + 2.199304925941878e-02 2.199055805969111e-02 2.198806947716193e-02 2.198558350490501e-02 2.198310014348315e-02 + 2.198061939050182e-02 2.197814123774413e-02 2.197566568143648e-02 2.197319271829654e-02 2.197072234409288e-02 + 2.196825456242376e-02 2.196578937054303e-02 2.196332674903257e-02 2.196086670076693e-02 2.195840923401799e-02 + 2.195595433798292e-02 2.195350200785295e-02 2.195105224287541e-02 2.194860503638501e-02 2.194616038337459e-02 + 2.194371828086876e-02 2.194127872478465e-02 2.193884171275727e-02 2.193640724439015e-02 2.193397531871202e-02 + 2.193154592984012e-02 2.192911906730429e-02 2.192669472874541e-02 2.192427291582612e-02 2.192185362988310e-02 + 2.191943685926103e-02 2.191702259589666e-02 2.191461084837004e-02 2.191220161094460e-02 2.190979487232746e-02 + 2.190739062981033e-02 2.190498888177591e-02 2.190258962778606e-02 2.190019287048831e-02 2.189779860038415e-02 + 2.189540680312951e-02 2.189301748590321e-02 2.189063064823816e-02 2.188824627921663e-02 2.188586438035036e-02 + 2.188348494945867e-02 2.188110797669410e-02 2.187873346273279e-02 2.187636140793982e-02 2.187399180563438e-02 + 2.187162464701073e-02 2.186925992764394e-02 2.186689765219864e-02 2.186453782016761e-02 2.186218042520733e-02 + 2.185982545624109e-02 2.185747291143151e-02 2.185512279286289e-02 2.185277509428750e-02 2.185042981497303e-02 + 2.184808695595145e-02 2.184574650317918e-02 2.184340845337333e-02 2.184107281435048e-02 2.183873957690715e-02 + 2.183640873122354e-02 2.183408027442373e-02 2.183175421068970e-02 2.182943053984947e-02 2.182710925220595e-02 + 2.182479034512406e-02 2.182247381639650e-02 2.182015965839264e-02 2.181784786935527e-02 2.181553844939510e-02 + 2.181323139439093e-02 2.181092669994856e-02 2.180862436262286e-02 2.180632438083940e-02 2.180402674952244e-02 + 2.180173146217098e-02 2.179943851892379e-02 2.179714791838810e-02 2.179485965603752e-02 2.179257372764807e-02 + 2.179029013045416e-02 2.178800886254997e-02 2.178572991731780e-02 2.178345329019238e-02 2.178117898198011e-02 + 2.177890698980304e-02 2.177663730909087e-02 2.177436993586566e-02 2.177210486810286e-02 2.176984210277431e-02 + 2.176758163245009e-02 2.176532345522340e-02 2.176306757137086e-02 2.176081397536724e-02 2.175856266623576e-02 + 2.175631364444715e-02 2.175406689861889e-02 2.175182242380624e-02 2.174958022311289e-02 2.174734029291431e-02 + 2.174510262809328e-02 2.174286722491656e-02 2.174063408336708e-02 2.173840320169586e-02 2.173617457340815e-02 + 2.173394819180500e-02 2.173172405255836e-02 2.172950215559655e-02 2.172728250040623e-02 2.172506508580887e-02 + 2.172284990969628e-02 2.172063696250313e-02 2.171842623537083e-02 2.171621773566752e-02 2.171401146093844e-02 + 2.171180740120238e-02 2.170960555830954e-02 2.170740592901658e-02 2.170520850408856e-02 2.170301328419004e-02 + 2.170082027006994e-02 2.169862945830807e-02 2.169644084240343e-02 2.169425441572978e-02 2.169207017401216e-02 + 2.168988812007480e-02 2.168770825534887e-02 2.168553057272023e-02 2.168335506533793e-02 2.168118172867985e-02 + 2.167901056214399e-02 2.167684156632982e-02 2.167467473989915e-02 2.167251007478243e-02 2.167034756604321e-02 + 2.166818721221639e-02 2.166602901099679e-02 2.166387295840019e-02 2.166171905012346e-02 2.165956728718834e-02 + 2.165741766632386e-02 2.165527017845730e-02 2.165312482355555e-02 2.165098160273919e-02 2.164884051303741e-02 + 2.164670154730472e-02 2.164456469954934e-02 2.164242996946321e-02 2.164029735885670e-02 2.163816686523918e-02 + 2.163603847533059e-02 2.163391219068715e-02 2.163178801684997e-02 2.162966593882407e-02 2.162754595404139e-02 + 2.162542806873079e-02 2.162331227177066e-02 2.162119856181649e-02 2.161908694674025e-02 2.161697741144211e-02 + 2.161486994763257e-02 2.161276456243416e-02 2.161066125301312e-02 2.160856001324272e-02 2.160646083892226e-02 + 2.160436373197112e-02 2.160226869104043e-02 2.160017570438035e-02 2.159808476849354e-02 2.159599588501710e-02 + 2.159390905460169e-02 2.159182427010056e-02 2.158974152429478e-02 2.158766082444429e-02 2.158558216760809e-02 + 2.158350554187339e-02 2.158143094233737e-02 2.157935837033232e-02 2.157728782941571e-02 2.157521931196140e-02 + 2.157315281164952e-02 2.157108832745493e-02 2.156902585566251e-02 2.156696539445298e-02 2.156490694526656e-02 + 2.156285049964247e-02 2.156079605212440e-02 2.155874360997529e-02 2.155669316474123e-02 2.155464470676604e-02 + 2.155259824484399e-02 2.155055377365348e-02 2.154851128035285e-02 2.154647076406023e-02 2.154443222886153e-02 + 2.154239567713112e-02 2.154036109691455e-02 2.153832848380287e-02 2.153629784162443e-02 2.153426916110383e-02 + 2.153224243839968e-02 2.153021767928900e-02 2.152819487735599e-02 2.152617402486068e-02 2.152415511969989e-02 + 2.152213816346627e-02 2.152012315489333e-02 2.151811008517867e-02 2.151609895106827e-02 2.151408975350627e-02 + 2.151208249405811e-02 2.151007716412923e-02 2.150807375412716e-02 2.150607227139823e-02 2.150407271389111e-02 + 2.150207507178008e-02 2.150007934512424e-02 2.149808553345600e-02 2.149609363244227e-02 2.149410363369511e-02 + 2.149211553597770e-02 2.149012934592863e-02 2.148814505588094e-02 2.148616265955859e-02 2.148418215959600e-02 + 2.148220354775919e-02 2.148022681859241e-02 2.147825198020547e-02 2.147627902590631e-02 2.147430794498996e-02 + 2.147233873858447e-02 2.147037140717467e-02 2.146840594879004e-02 2.146644235912430e-02 2.146448063553682e-02 + 2.146252077578778e-02 2.146056277288728e-02 2.145860662318243e-02 2.145665232726965e-02 2.145469988438242e-02 + 2.145274929256557e-02 2.145080054831608e-02 2.144885364454498e-02 2.144690857746641e-02 2.144496534942983e-02 + 2.144302395654175e-02 2.144108439499599e-02 2.143914666610025e-02 2.143721076355154e-02 2.143527668029283e-02 + 2.143334441800114e-02 2.143141397685691e-02 2.142948535268880e-02 2.142755853497146e-02 2.142563352602930e-02 + 2.142371033388222e-02 2.142178894500280e-02 2.141986935358769e-02 2.141795156402302e-02 2.141603556793572e-02 + 2.141412136230918e-02 2.141220895321441e-02 2.141029833297722e-02 2.140838949470163e-02 2.140648244009975e-02 + 2.140457716697424e-02 2.140267367166504e-02 2.140077195168551e-02 2.139887200433115e-02 2.139697382547902e-02 + 2.139507740888590e-02 2.139318275720074e-02 2.139128987343195e-02 2.138939874415982e-02 2.138750936775835e-02 + 2.138562175102568e-02 2.138373588641631e-02 2.138185176599392e-02 2.137996938652284e-02 2.137808875223814e-02 + 2.137620986251236e-02 2.137433270909064e-02 2.137245728978030e-02 2.137058360186242e-02 2.136871163953864e-02 + 2.136684140688612e-02 2.136497290390506e-02 2.136310611597474e-02 2.136124104345297e-02 2.135937769212130e-02 + 2.135751605860686e-02 2.135565613610374e-02 2.135379791822062e-02 2.135194140402438e-02 2.135008659417071e-02 + 2.134823348788390e-02 2.134638207760105e-02 2.134453236032835e-02 2.134268433814086e-02 2.134083800772077e-02 + 2.133899336411597e-02 2.133715040305821e-02 2.133530912424798e-02 2.133346952672500e-02 2.133163160670673e-02 + 2.132979536297411e-02 2.132796079152963e-02 2.132612788229375e-02 2.132429663915477e-02 2.132246706798375e-02 + 2.132063916037057e-02 2.131881290769116e-02 2.131698830582932e-02 2.131516535978050e-02 2.131334407028698e-02 + 2.131152443198118e-02 2.130970643552249e-02 2.130789007885127e-02 2.130607536669811e-02 2.130426229682303e-02 + 2.130245086421657e-02 2.130064106313053e-02 2.129883288837854e-02 2.129702633875496e-02 2.129522141788389e-02 + 2.129341812290223e-02 2.129161644909972e-02 2.128981639414264e-02 2.128801795585396e-02 2.128622113110773e-02 + 2.128442591509673e-02 2.128263230760480e-02 2.128084030772261e-02 2.127904990395241e-02 2.127726109953179e-02 + 2.127547390424031e-02 2.127368830171838e-02 2.127190428479188e-02 2.127012186038021e-02 2.126834102886177e-02 + 2.126656178481652e-02 2.126478411995624e-02 2.126300803603507e-02 2.126123353191450e-02 2.125946059821390e-02 + 2.125768923851055e-02 2.125591945439615e-02 2.125415123382016e-02 2.125238457915817e-02 2.125061949358618e-02 + 2.124885596288304e-02 2.124709398735697e-02 2.124533357303348e-02 2.124357470952245e-02 2.124181739435340e-02 + 2.124006163206048e-02 2.123830741948956e-02 2.123655475001017e-02 2.123480361731545e-02 2.123305402409987e-02 + 2.123130596739953e-02 2.122955943693203e-02 2.122781443910126e-02 2.122607097723360e-02 2.122432904130337e-02 + 2.122258862659696e-02 2.122084973282204e-02 2.121911236175234e-02 2.121737650789419e-02 2.121564216387619e-02 + 2.121390932803162e-02 2.121217800425756e-02 2.121044819455527e-02 2.120871988671843e-02 2.120699307684077e-02 + 2.120526776795157e-02 2.120354395552526e-02 2.120182163603621e-02 2.120010080901829e-02 2.119838147500087e-02 + 2.119666363123091e-02 2.119494727091758e-02 2.119323238927472e-02 2.119151898655034e-02 2.118980706773010e-02 + 2.118809662574528e-02 2.118638765303925e-02 2.118468015121633e-02 2.118297411864271e-02 2.118126955146517e-02 + 2.117956644637810e-02 2.117786480292237e-02 2.117616462067450e-02 2.117446589411339e-02 2.117276862084477e-02 + 2.117107280130004e-02 2.116937843379139e-02 2.116768551256503e-02 2.116599403067535e-02 2.116430399205533e-02 + 2.116261539753040e-02 2.116092824074994e-02 2.115924251858398e-02 2.115755822756320e-02 2.115587536308644e-02 + 2.115419393062315e-02 2.115251393109511e-02 2.115083534999197e-02 2.114915818684827e-02 2.114748244571777e-02 + 2.114580812117730e-02 2.114413521000233e-02 2.114246371011731e-02 2.114079361630021e-02 2.113912493113981e-02 + 2.113745765864524e-02 2.113579178347091e-02 2.113412730283017e-02 2.113246422731517e-02 2.113080255018658e-02 + 2.112914226466844e-02 2.112748336987266e-02 2.112582586239263e-02 2.112416973838773e-02 2.112251499585494e-02 + 2.112086163946853e-02 2.111920966923609e-02 2.111755907231158e-02 2.111590984741022e-02 2.111426199652882e-02 + 2.111261551330255e-02 2.111097039854193e-02 2.110932665501722e-02 2.110768427494188e-02 2.110604325159932e-02 + 2.110440358337455e-02 2.110276527755971e-02 2.110112832954347e-02 2.109949272542061e-02 2.109785847270291e-02 + 2.109622557382813e-02 2.109459401840321e-02 2.109296380279178e-02 2.109133492634166e-02 2.108970738897449e-02 + 2.108808119187406e-02 2.108645633261542e-02 2.108483280177793e-02 2.108321059649476e-02 2.108158971816587e-02 + 2.107997016818712e-02 2.107835194176262e-02 2.107673503228282e-02 2.107511943992769e-02 2.107350516482023e-02 + 2.107189220511111e-02 2.107028055587330e-02 2.106867021606288e-02 2.106706118735907e-02 2.106545346293816e-02 + 2.106384703796383e-02 2.106224191316689e-02 2.106063808955507e-02 2.105903556250238e-02 2.105743432153898e-02 + 2.105583437513380e-02 2.105423572746437e-02 2.105263836035830e-02 2.105104227142354e-02 2.104944746729932e-02 + 2.104785395134047e-02 2.104626171573087e-02 2.104467074966839e-02 2.104308105452007e-02 2.104149263222363e-02 + 2.103990548218236e-02 2.103831959968388e-02 2.103673498293864e-02 2.103515163200819e-02 2.103356953798411e-02 + 2.103198869775456e-02 2.103040911733209e-02 2.102883079574534e-02 2.102725372695269e-02 2.102567790273802e-02 + 2.102410332486244e-02 2.102252999507990e-02 2.102095790737760e-02 2.101938706174730e-02 2.101781745879964e-02 + 2.101624909192282e-02 2.101468195450770e-02 2.101311604447429e-02 2.101155137000445e-02 2.100998792857284e-02 + 2.100842571064132e-02 2.100686471849675e-02 2.100530495078897e-02 2.100374640001838e-02 2.100218906014547e-02 + 2.100063293273019e-02 2.099907802537045e-02 2.099752433031871e-02 2.099597184169578e-02 2.099442056340826e-02 + 2.099287048844137e-02 2.099132161182849e-02 2.098977394056553e-02 2.098822746767990e-02 2.098668218492037e-02 + 2.098513809937855e-02 2.098359520656010e-02 2.098205349870481e-02 2.098051298433238e-02 2.097897365788888e-02 + 2.097743550607582e-02 2.097589853771057e-02 2.097436275317134e-02 2.097282814179318e-02 2.097129470444368e-02 + 2.096976244194844e-02 2.096823135057212e-02 2.096670142502171e-02 2.096517266432222e-02 2.096364507294766e-02 + 2.096211864290872e-02 2.096059336882086e-02 2.095906925902597e-02 2.095754630598820e-02 2.095602449947026e-02 + 2.095450384463222e-02 2.095298434369944e-02 2.095146599313072e-02 2.094994878341327e-02 2.094843271500539e-02 + 2.094691779352117e-02 2.094540401073429e-02 2.094389136288097e-02 2.094237985194064e-02 2.094086947133280e-02 + 2.093936021927527e-02 2.093785210108921e-02 2.093634511142213e-02 2.093483924325246e-02 2.093333449385128e-02 + 2.093183086645815e-02 2.093032836253444e-02 2.092882697593887e-02 2.092732670311165e-02 2.092582754108962e-02 + 2.092432948474122e-02 2.092283253800634e-02 2.092133670446908e-02 2.091984196956714e-02 2.091834833166288e-02 + 2.091685579922333e-02 2.091536436905392e-02 2.091387403364116e-02 2.091238478662568e-02 2.091089663391256e-02 + 2.090940957508328e-02 2.090792359986955e-02 2.090643871032298e-02 2.090495490818039e-02 2.090347218811059e-02 + 2.090199054718417e-02 2.090050998308706e-02 2.089903049243704e-02 2.089755207414248e-02 2.089607472810411e-02 + 2.089459845325996e-02 2.089312324594328e-02 2.089164910255710e-02 2.089017602427597e-02 2.088870401009232e-02 + 2.088723305634642e-02 2.088576315893389e-02 2.088429431601771e-02 2.088282652696964e-02 2.088135978615913e-02 + 2.087989409321534e-02 2.087842945395569e-02 2.087696586275656e-02 2.087550331287119e-02 2.087404180207852e-02 + 2.087258132736208e-02 2.087112188861259e-02 2.086966349090147e-02 2.086820612891688e-02 2.086674979608584e-02 + 2.086529449590395e-02 2.086384022331517e-02 2.086238697045790e-02 2.086093474039187e-02 2.085948353444753e-02 + 2.085803335091995e-02 2.085658418796912e-02 2.085513604081134e-02 2.085368890289571e-02 2.085224277300881e-02 + 2.085079765267601e-02 2.084935354393509e-02 2.084791044341373e-02 2.084646834711395e-02 2.084502725286095e-02 + 2.084358715744794e-02 2.084214805848912e-02 2.084070995598070e-02 2.083927284909677e-02 2.083783673573611e-02 + 2.083640161226469e-02 2.083496747523998e-02 2.083353432223483e-02 2.083210215303235e-02 2.083067096927498e-02 + 2.082924077044086e-02 2.082781154460241e-02 2.082638329211299e-02 2.082495602309350e-02 2.082352972509603e-02 + 2.082210439277076e-02 2.082068003454410e-02 2.081925664261260e-02 2.081783421113447e-02 2.081641274508624e-02 + 2.081499224082686e-02 2.081357269450268e-02 2.081215410878219e-02 2.081073647873721e-02 2.080931979776872e-02 + 2.080790406592918e-02 2.080648928500749e-02 2.080507545608266e-02 2.080366257645188e-02 2.080225063919177e-02 + 2.080083963814898e-02 2.079942957984240e-02 2.079802046255642e-02 2.079661227641324e-02 2.079520502452446e-02 + 2.079379870732677e-02 2.079239331877295e-02 2.079098886066600e-02 2.078958533155146e-02 2.078818272238310e-02 + 2.078678103594075e-02 2.078538027480030e-02 2.078398043169412e-02 2.078258150517176e-02 2.078118349582184e-02 + 2.077978640032045e-02 2.077839021518007e-02 2.077699493798996e-02 2.077560056860569e-02 2.077420710626992e-02 + 2.077281454908150e-02 2.077142289397691e-02 2.077003213665487e-02 2.076864227381708e-02 2.076725331084939e-02 + 2.076586524753700e-02 2.076447807479244e-02 2.076309178893910e-02 2.076170639200464e-02 2.076032188924749e-02 + 2.075893827075576e-02 2.075755552867013e-02 2.075617367037054e-02 2.075479269394757e-02 2.075341259415677e-02 + 2.075203337133167e-02 2.075065502119062e-02 2.074927754004291e-02 2.074790093527532e-02 2.074652520196147e-02 + 2.074515032814618e-02 2.074377631824518e-02 2.074240317461906e-02 2.074103089389617e-02 2.073965947285912e-02 + 2.073828890806665e-02 2.073691919635770e-02 2.073555033844026e-02 2.073418233381763e-02 2.073281517823886e-02 + 2.073144886803073e-02 2.073008340377233e-02 2.072871879147831e-02 2.072735502222402e-02 2.072599208688765e-02 + 2.072462999392301e-02 2.072326873860233e-02 2.072190831224300e-02 2.072054872378210e-02 2.071918997148765e-02 + 2.071783204556565e-02 2.071647494755481e-02 2.071511867766477e-02 2.071376323196711e-02 2.071240860565183e-02 + 2.071105479791370e-02 2.070970181180314e-02 2.070834964331268e-02 2.070699828917085e-02 2.070564775075080e-02 + 2.070429802727900e-02 2.070294911380581e-02 2.070160100113699e-02 2.070025369244763e-02 2.069890719322030e-02 + 2.069756149841416e-02 2.069621660331007e-02 2.069487250616514e-02 2.069352920972353e-02 2.069218670843115e-02 + 2.069084499406914e-02 2.068950407478504e-02 2.068816395008570e-02 2.068682460979861e-02 2.068548605525363e-02 + 2.068414828647597e-02 2.068281129879088e-02 2.068147509294542e-02 2.068013966727868e-02 2.067880501481977e-02 + 2.067747113766845e-02 2.067613803889334e-02 2.067480571527677e-02 2.067347415977921e-02 2.067214336769299e-02 + 2.067081334319025e-02 2.066948408776949e-02 2.066815559807265e-02 2.066682786498898e-02 2.066550088830383e-02 + 2.066417467341183e-02 2.066284921698086e-02 2.066152451475288e-02 2.066020056372571e-02 2.065887736182303e-02 + 2.065755490839281e-02 2.065623320354572e-02 2.065491224367795e-02 2.065359202675738e-02 2.065227255436574e-02 + 2.065095382314874e-02 2.064963582941213e-02 2.064831857270797e-02 2.064700204957123e-02 2.064568625651786e-02 + 2.064437119414936e-02 2.064305686324694e-02 2.064174326345409e-02 2.064043039179931e-02 2.063911824280925e-02 + 2.063780681176866e-02 2.063649610237503e-02 2.063518611610314e-02 2.063387684909248e-02 2.063256829217405e-02 + 2.063126044539576e-02 2.062995331851188e-02 2.062864690334512e-02 2.062734119190086e-02 2.062603618600375e-02 + 2.062473188642144e-02 2.062342829221786e-02 2.062212540064643e-02 2.062082320714733e-02 2.061952170915304e-02 + 2.061822091004314e-02 2.061692080716460e-02 2.061562139605911e-02 2.061432267954307e-02 2.061302465323251e-02 + 2.061172730955065e-02 2.061043065371613e-02 2.060913468523504e-02 2.060783939685846e-02 2.060654478913799e-02 + 2.060525086119714e-02 2.060395760866959e-02 2.060266503271371e-02 2.060137313244415e-02 2.060008190215519e-02 + 2.059879134465455e-02 2.059750146004468e-02 2.059621223782829e-02 2.059492368052522e-02 2.059363579225837e-02 + 2.059234856405708e-02 2.059106199328788e-02 2.058977608130871e-02 2.058849082556723e-02 2.058720622498806e-02 + 2.058592227959311e-02 2.058463898696043e-02 2.058335634281647e-02 2.058207434376584e-02 2.058079299573017e-02 + 2.057951229614279e-02 2.057823223269817e-02 2.057695281356401e-02 2.057567404187197e-02 2.057439590387300e-02 + 2.057311839681732e-02 2.057184152455586e-02 2.057056529173392e-02 2.056928969078429e-02 2.056801471376779e-02 + 2.056674036634529e-02 2.056546664830153e-02 2.056419355486686e-02 2.056292108306100e-02 2.056164923170236e-02 + 2.056037800067255e-02 2.055910738924650e-02 2.055783739340399e-02 2.055656800859636e-02 2.055529924146672e-02 + 2.055403109005562e-02 2.055276354110791e-02 2.055149659755915e-02 2.055023026272679e-02 2.054896453244645e-02 + 2.054769940766287e-02 2.054643488681757e-02 2.054517096062926e-02 2.054390763218316e-02 2.054264490512525e-02 + 2.054138276915942e-02 2.054012122328143e-02 2.053886027085424e-02 2.053759990682471e-02 2.053634012878631e-02 + 2.053508093799464e-02 2.053382233647706e-02 2.053256431985532e-02 2.053130687980379e-02 2.053005001911220e-02 + 2.052879373804411e-02 2.052753803104820e-02 2.052628289842169e-02 2.052502834052905e-02 2.052377435424499e-02 + 2.052252093383405e-02 2.052126807833591e-02 2.052001579579881e-02 2.051876408076618e-02 2.051751292558091e-02 + 2.051626233431153e-02 2.051501230108543e-02 2.051376281904528e-02 2.051251389905356e-02 2.051126553806812e-02 + 2.051001772450580e-02 2.050877046477720e-02 2.050752375748313e-02 2.050627759308629e-02 2.050503197764233e-02 + 2.050378691120845e-02 2.050254238346269e-02 2.050129839647772e-02 2.050005495152270e-02 2.049881204279591e-02 + 2.049756967049427e-02 2.049632783497685e-02 2.049508653204386e-02 2.049384576061373e-02 2.049260552085964e-02 + 2.049136581124810e-02 2.049012662828215e-02 2.048888796855573e-02 2.048764983217528e-02 2.048641222055239e-02 + 2.048517513365279e-02 2.048393856449956e-02 2.048270250702790e-02 2.048146696002243e-02 2.048023193267689e-02 + 2.047899742444990e-02 2.047776342204647e-02 2.047652992557144e-02 2.047529693666283e-02 2.047406445284291e-02 + 2.047283247820367e-02 2.047160101124722e-02 2.047037003705319e-02 2.046913955996649e-02 2.046790958805229e-02 + 2.046668011290463e-02 2.046545112747173e-02 2.046422263048016e-02 2.046299462941648e-02 2.046176712182623e-02 + 2.046054009863872e-02 2.045931356011635e-02 2.045808750875261e-02 2.045686194483555e-02 2.045563685869128e-02 + 2.045441224888558e-02 2.045318812405373e-02 2.045196447539730e-02 2.045074129851060e-02 2.044951860203706e-02 + 2.044829637561388e-02 2.044707461146781e-02 2.044585332076453e-02 2.044463250090934e-02 2.044341214478788e-02 + 2.044219225389736e-02 2.044097282684260e-02 2.043975385980242e-02 2.043853534979080e-02 2.043731729516990e-02 + 2.043609969584751e-02 2.043488255365452e-02 2.043366586840525e-02 2.043244963622695e-02 2.043123384788510e-02 + 2.043001850356880e-02 2.042880361352058e-02 2.042758917125052e-02 2.042637516923373e-02 2.042516160738241e-02 + 2.042394848596822e-02 2.042273580364956e-02 2.042152355668345e-02 2.042031174421715e-02 2.041910036711696e-02 + 2.041788942589821e-02 2.041667891618270e-02 2.041546883283581e-02 2.041425917723074e-02 2.041304994671302e-02 + 2.041184113736942e-02 2.041063275507356e-02 2.040942479864618e-02 2.040821725911453e-02 2.040701013329647e-02 + 2.040580342336421e-02 2.040459713364973e-02 2.040339125626194e-02 2.040218578748979e-02 2.040098073437600e-02 + 2.039977609190064e-02 2.039857185194057e-02 2.039736801200263e-02 2.039616457948628e-02 2.039496155847034e-02 + 2.039375893548800e-02 2.039255670811317e-02 2.039135487906758e-02 2.039015344139171e-02 2.038895239754324e-02 + 2.038775175394349e-02 2.038655150008423e-02 2.038535163468296e-02 2.038415216492024e-02 2.038295307932101e-02 + 2.038175437156158e-02 2.038055604740632e-02 2.037935811014152e-02 2.037816055719221e-02 2.037696338008003e-02 + 2.037576657774965e-02 2.037457015197002e-02 2.037337410306159e-02 2.037217842811476e-02 2.037098312337542e-02 + 2.036978818702816e-02 2.036859361901312e-02 2.036739941883561e-02 2.036620558232109e-02 2.036501210897116e-02 + 2.036381899981477e-02 2.036262624936801e-02 2.036143385733716e-02 2.036024182706139e-02 2.035905014947786e-02 + 2.035785882153747e-02 2.035666784977269e-02 2.035547723079831e-02 2.035428696142468e-02 2.035309704319765e-02 + 2.035190747134853e-02 2.035071824110532e-02 2.034952935293085e-02 2.034834080749865e-02 2.034715260430401e-02 + 2.034596474052595e-02 2.034477721202228e-02 2.034359001578161e-02 2.034240315367684e-02 2.034121662664043e-02 + 2.034003043357028e-02 2.033884457132868e-02 2.033765903741480e-02 2.033647382949949e-02 2.033528894162872e-02 + 2.033410437471255e-02 2.033292013620119e-02 2.033173621775026e-02 2.033055261459435e-02 2.032936933387398e-02 + 2.032818637173341e-02 2.032700371995237e-02 2.032582137330103e-02 2.032463934032926e-02 2.032345762721536e-02 + 2.032227621977112e-02 2.032109511380310e-02 2.031991431266943e-02 2.031873381713771e-02 2.031755362367381e-02 + 2.031637372822898e-02 2.031519413522404e-02 2.031401484060572e-02 2.031283583475656e-02 2.031165712768451e-02 + 2.031047872082618e-02 2.030930060067025e-02 2.030812276414845e-02 2.030694521582938e-02 2.030576796297434e-02 + 2.030459099391277e-02 2.030341430130414e-02 2.030223789822972e-02 2.030106177803277e-02 2.029988592949474e-02 + 2.029871035725545e-02 2.029753506661443e-02 2.029636005659757e-02 2.029518531267896e-02 2.029401083596470e-02 + 2.029283663654064e-02 2.029166270589052e-02 2.029048903923464e-02 2.028931563858370e-02 2.028814250195392e-02 + 2.028696962711050e-02 2.028579701358946e-02 2.028462466440920e-02 2.028345257575578e-02 2.028228073462766e-02 + 2.028110914546667e-02 2.027993781542017e-02 2.027876674182124e-02 2.027759591671596e-02 2.027642533515473e-02 + 2.027525500323221e-02 2.027408491983729e-02 2.027291508043819e-02 2.027174548650143e-02 2.027057613494678e-02 + 2.026940701983228e-02 2.026823814087089e-02 2.026706949898955e-02 2.026590109425394e-02 2.026473292320746e-02 + 2.026356498366547e-02 2.026239727592488e-02 2.026122979922282e-02 2.026006255023894e-02 2.025889552388743e-02 + 2.025772872449768e-02 2.025656215399196e-02 2.025539580342713e-02 2.025422967119250e-02 2.025306375830951e-02 + 2.025189806183918e-02 2.025073258129647e-02 2.024956731656576e-02 2.024840226339874e-02 2.024723742127980e-02 + 2.024607279125879e-02 2.024490836776212e-02 2.024374415071052e-02 2.024258014353189e-02 2.024141633571028e-02 + 2.024025272656142e-02 2.023908932762591e-02 2.023792612793740e-02 2.023676312010299e-02 2.023560031179207e-02 + 2.023443769779265e-02 2.023327527310789e-02 2.023211304323675e-02 2.023095100708355e-02 2.022978916007167e-02 + 2.022862749919407e-02 2.022746602379288e-02 2.022630473371739e-02 2.022514362648272e-02 2.022398270121405e-02 + 2.022282195791762e-02 2.022166139402294e-02 2.022050100551405e-02 2.021934078921764e-02 2.021818074920451e-02 + 2.021702088593813e-02 2.021586119314628e-02 2.021470166428228e-02 2.021354230080554e-02 2.021238311308448e-02 + 2.021122409287018e-02 2.021006523025651e-02 2.020890652716039e-02 2.020774798484683e-02 2.020658960393083e-02 + 2.020543138529554e-02 2.020427332378045e-02 2.020311541298552e-02 2.020195765397637e-02 2.020080004744672e-02 + 2.019964259236717e-02 2.019848528642001e-02 2.019732812869024e-02 2.019617111926010e-02 2.019501425544548e-02 + 2.019385753379127e-02 2.019270095135025e-02 2.019154450793482e-02 2.019038820298517e-02 2.018923203417478e-02 + 2.018807600019563e-02 2.018692010151906e-02 2.018576433995726e-02 2.018460870891364e-02 2.018345320296787e-02 + 2.018229782843392e-02 2.018114258172615e-02 2.017998745649097e-02 2.017883245877245e-02 2.017767758620927e-02 + 2.017652283054322e-02 2.017536819223788e-02 2.017421367319040e-02 2.017305927292809e-02 2.017190498313902e-02 + 2.017075080461503e-02 2.016959674752286e-02 2.016844280049332e-02 2.016728895684716e-02 2.016613522539111e-02 + 2.016498159847723e-02 2.016382807033869e-02 2.016267465040216e-02 2.016152133310211e-02 2.016036811076429e-02 + 2.015921498985646e-02 2.015806197025070e-02 2.015690904702832e-02 2.015575621731957e-02 2.015460347791708e-02 + 2.015345082711757e-02 2.015229826996444e-02 2.015114580452791e-02 2.014999342256183e-02 2.014884112402139e-02 + 2.014768891079059e-02 2.014653678283008e-02 2.014538473229735e-02 2.014423275838842e-02 2.014308087159530e-02 + 2.014192906336537e-02 2.014077732405132e-02 2.013962565684693e-02 2.013847406112768e-02 2.013732253607323e-02 + 2.013617108558620e-02 2.013501970367529e-02 2.013386838304751e-02 2.013271713092954e-02 2.013156594450895e-02 + 2.013041481517404e-02 2.012926374836556e-02 2.012811274375330e-02 2.012696179396415e-02 2.012581089842930e-02 + 2.012466005832842e-02 2.012350927388322e-02 2.012235854139777e-02 2.012120785897021e-02 2.012005722808521e-02 + 2.011890664240422e-02 2.011775609861771e-02 2.011660560342765e-02 2.011545514995805e-02 2.011430473248947e-02 + 2.011315436328775e-02 2.011200403690588e-02 2.011085374071231e-02 2.010970347811273e-02 2.010855325123000e-02 + 2.010740305829795e-02 2.010625289543029e-02 2.010510276184403e-02 2.010395265874816e-02 2.010280258124321e-02 + 2.010165252783862e-02 2.010050250168409e-02 2.009935249835288e-02 2.009820251528310e-02 2.009705255512517e-02 + 2.009590261098061e-02 2.009475267797075e-02 2.009360276160796e-02 2.009245286068316e-02 2.009130297235736e-02 + 2.009015309860190e-02 2.008900323371492e-02 2.008785337125678e-02 2.008670351711407e-02 2.008555367122358e-02 + 2.008440382812401e-02 2.008325398588614e-02 2.008210414433437e-02 2.008095430334925e-02 2.007980445913736e-02 + 2.007865461009197e-02 2.007750475755383e-02 2.007635489836262e-02 2.007520502856765e-02 2.007405514609401e-02 + 2.007290525369839e-02 2.007175535352643e-02 2.007060544261636e-02 2.006945551378952e-02 2.006830556246986e-02 + 2.006715559358176e-02 2.006600560685722e-02 2.006485559907452e-02 2.006370557035152e-02 2.006255552017783e-02 + 2.006140544519211e-02 2.006025533608720e-02 2.005910519424486e-02 2.005795502866486e-02 2.005680483150780e-02 + 2.005565460068358e-02 2.005450434307724e-02 2.005335404752871e-02 2.005220370751987e-02 2.005105333078331e-02 + 2.004990291380246e-02 2.004875245256121e-02 2.004760195075808e-02 2.004645140541610e-02 2.004530081249103e-02 + 2.004415017386308e-02 2.004299948719255e-02 2.004184874893760e-02 2.004069796075558e-02 2.003954711861807e-02 + 2.003839621652469e-02 2.003724525928808e-02 2.003609424691447e-02 2.003494317431652e-02 2.003379204407136e-02 + 2.003264085311753e-02 2.003148959193977e-02 2.003033826577724e-02 2.002918687817827e-02 2.002803542325049e-02 + 2.002688389828578e-02 2.002573230084169e-02 2.002458062668545e-02 2.002342887779152e-02 2.002227705716231e-02 + 2.002112516254241e-02 2.001997318998642e-02 2.001882113644655e-02 2.001766900292078e-02 2.001651678857442e-02 + 2.001536448981540e-02 2.001421210083374e-02 2.001305962366636e-02 2.001190706486020e-02 2.001075441600587e-02 + 2.000960167234195e-02 2.000844883687991e-02 2.000729590520412e-02 2.000614287591466e-02 2.000498975435740e-02 + 2.000383653574291e-02 2.000268321490327e-02 2.000152979351511e-02 2.000037626872929e-02 1.999922263743778e-02 + 1.999806890154111e-02 1.999691505794393e-02 1.999576110265488e-02 1.999460703886217e-02 1.999345286480270e-02 + 1.999229857569377e-02 1.999114417297134e-02 1.998998965543275e-02 1.998883501902821e-02 1.998768026399775e-02 + 1.998652538946059e-02 1.998537039260291e-02 1.998421527483334e-02 1.998306003351848e-02 1.998190465988335e-02 + 1.998074915750420e-02 1.997959352937345e-02 1.997843776879367e-02 1.997728187765045e-02 1.997612585705249e-02 + 1.997496969649909e-02 1.997381339760593e-02 1.997265696528752e-02 1.997150039002939e-02 1.997034367059401e-02 + 1.996918681208352e-02 1.996802981226081e-02 1.996687266788810e-02 1.996571537594770e-02 1.996455793197006e-02 + 1.996340033608642e-02 1.996224259309599e-02 1.996108470119043e-02 1.995992665416334e-02 1.995876844505867e-02 + 1.995761008193637e-02 1.995645156786617e-02 1.995529288784624e-02 1.995413404457776e-02 1.995297504246996e-02 + 1.995181586885687e-02 1.995065652904149e-02 1.994949703248385e-02 1.994833736513130e-02 1.994717752162546e-02 + 1.994601750553184e-02 1.994485731663886e-02 1.994369695406686e-02 1.994253641736701e-02 1.994137570693218e-02 + 1.994021481716852e-02 1.993905373876526e-02 1.993789248152490e-02 1.993673104732284e-02 1.993556942048493e-02 + 1.993440760773439e-02 1.993324561433191e-02 1.993208342679873e-02 1.993092104568069e-02 1.992975847582151e-02 + 1.992859571315939e-02 1.992743275300710e-02 1.992626959353599e-02 1.992510623927749e-02 1.992394268911061e-02 + 1.992277893654564e-02 1.992161497535049e-02 1.992045080942924e-02 1.991928644769617e-02 1.991812187931771e-02 + 1.991695709651699e-02 1.991579210148713e-02 1.991462689658082e-02 1.991346148075462e-02 1.991229584907280e-02 + 1.991113000189043e-02 1.990996393932216e-02 1.990879765723607e-02 1.990763115454515e-02 1.990646443148474e-02 + 1.990529748687400e-02 1.990413031580006e-02 1.990296291532720e-02 1.990179529310021e-02 1.990062744303953e-02 + 1.989945935329500e-02 1.989829103342642e-02 1.989712248515872e-02 1.989595370004318e-02 1.989478467737964e-02 + 1.989361541884726e-02 1.989244592499573e-02 1.989127618925862e-02 1.989010620674421e-02 1.988893597834538e-02 + 1.988776550466197e-02 1.988659478703524e-02 1.988542382727661e-02 1.988425261506333e-02 1.988308114268849e-02 + 1.988190942098788e-02 1.988073745006194e-02 1.987956522359536e-02 1.987839274079954e-02 1.987722000000555e-02 + 1.987604699732070e-02 1.987487372670402e-02 1.987370019241589e-02 1.987252640362364e-02 1.987135234678179e-02 + 1.987017801708705e-02 1.986900342417090e-02 1.986782856130232e-02 1.986665342124566e-02 1.986547800516037e-02 + 1.986430231940191e-02 1.986312636323797e-02 1.986195012209680e-02 1.986077359858922e-02 1.985959679883774e-02 + 1.985841971608161e-02 1.985724235007767e-02 1.985606470192896e-02 1.985488676268764e-02 1.985370853173279e-02 + 1.985253001389235e-02 1.985135120589531e-02 1.985017210671596e-02 1.984899271721913e-02 1.984781303008921e-02 + 1.984663304141680e-02 1.984545275323681e-02 1.984427216416261e-02 1.984309127447186e-02 1.984191008724042e-02 + 1.984072859600846e-02 1.983954679442092e-02 1.983836468369445e-02 1.983718226650526e-02 1.983599954091759e-02 + 1.983481649574990e-02 1.983363313683907e-02 1.983244947316962e-02 1.983126549121019e-02 1.983008118452795e-02 + 1.982889655650101e-02 1.982771161407836e-02 1.982652635127155e-02 1.982534075477381e-02 1.982415483542671e-02 + 1.982296859699974e-02 1.982178202865004e-02 1.982059512679342e-02 1.981940789099672e-02 1.981822032140366e-02 + 1.981703241807743e-02 1.981584417989424e-02 1.981465560415464e-02 1.981346669171603e-02 1.981227744136961e-02 + 1.981108784415540e-02 1.980989790130036e-02 1.980870761757638e-02 1.980751698807925e-02 1.980632600934410e-02 + 1.980513468056937e-02 1.980394300171975e-02 1.980275097143216e-02 1.980155858653555e-02 1.980036584235624e-02 + 1.979917273943820e-02 1.979797928262491e-02 1.979678546489206e-02 1.979559128379798e-02 1.979439674657348e-02 + 1.979320184217468e-02 1.979200656369760e-02 1.979081092352834e-02 1.978961491694981e-02 1.978841853542797e-02 + 1.978722178317891e-02 1.978602465925507e-02 1.978482715855289e-02 1.978362927697639e-02 1.978243101628911e-02 + 1.978123238058121e-02 1.978003336668686e-02 1.977883396860304e-02 1.977763418131442e-02 1.977643400902304e-02 + 1.977523345232920e-02 1.977403250607500e-02 1.977283117205557e-02 1.977162944865208e-02 1.977042732702634e-02 + 1.976922480613855e-02 1.976802188997964e-02 1.976681858355301e-02 1.976561487769950e-02 1.976441076369096e-02 + 1.976320624890566e-02 1.976200133147697e-02 1.976079600616600e-02 1.975959027757971e-02 1.975838414138116e-02 + 1.975717758909272e-02 1.975597062600439e-02 1.975476325369590e-02 1.975355546738499e-02 1.975234726242962e-02 + 1.975113863825908e-02 1.974992959762522e-02 1.974872013640206e-02 1.974751025163228e-02 1.974629994489470e-02 + 1.974508921425132e-02 1.974387805573186e-02 1.974266646519683e-02 1.974145444319864e-02 1.974024199150465e-02 + 1.973902910920840e-02 1.973781579519036e-02 1.973660204598839e-02 1.973538785240977e-02 1.973417321684443e-02 + 1.973295814730416e-02 1.973174263781577e-02 1.973052668253849e-02 1.972931027913797e-02 1.972809342747564e-02 + 1.972687612827085e-02 1.972565838187941e-02 1.972444018482310e-02 1.972322153363352e-02 1.972200242687443e-02 + 1.972078286440720e-02 1.971956284541047e-02 1.971834236691286e-02 1.971712142485657e-02 1.971590001741145e-02 + 1.971467814826898e-02 1.971345581852119e-02 1.971223302479186e-02 1.971100975804211e-02 1.970978601823674e-02 + 1.970856181065497e-02 1.970733713228995e-02 1.970611197806177e-02 1.970488634450282e-02 1.970366023582840e-02 + 1.970243364879734e-02 1.970120657299705e-02 1.969997901837739e-02 1.969875098677333e-02 1.969752246217473e-02 + 1.969629345274012e-02 1.969506396226801e-02 1.969383397141272e-02 1.969260348756574e-02 1.969137252109090e-02 + 1.969014105730648e-02 1.968890909233832e-02 1.968767662961491e-02 1.968644366805134e-02 1.968521020635475e-02 + 1.968397624286150e-02 1.968274177331172e-02 1.968150679588088e-02 1.968027131148579e-02 1.967903532058098e-02 + 1.967779882218197e-02 1.967656181292412e-02 1.967532428489620e-02 1.967408623811289e-02 1.967284768294825e-02 + 1.967160860971293e-02 1.967036900987211e-02 1.966912889102269e-02 1.966788825153749e-02 1.966664708600774e-02 + 1.966540539310703e-02 1.966416317292449e-02 1.966292042476060e-02 1.966167714455673e-02 1.966043333167102e-02 + 1.965918898702837e-02 1.965794410650064e-02 1.965669868705162e-02 1.965545272765306e-02 1.965420622710374e-02 + 1.965295918609461e-02 1.965171160585919e-02 1.965046347855766e-02 1.964921480087875e-02 1.964796557872257e-02 + 1.964671580769246e-02 1.964546548231519e-02 1.964421460325605e-02 1.964296317129598e-02 1.964171118580111e-02 + 1.964045864365522e-02 1.963920554157133e-02 1.963795187629582e-02 1.963669764477085e-02 1.963544284945441e-02 + 1.963418749362842e-02 1.963293156932153e-02 1.963167507295046e-02 1.963041800662418e-02 1.962916036936736e-02 + 1.962790216073956e-02 1.962664338014056e-02 1.962538401760687e-02 1.962412407160046e-02 1.962286355381917e-02 + 1.962160245501161e-02 1.962034076606272e-02 1.961907849332115e-02 1.961781563715828e-02 1.961655219371613e-02 + 1.961528815879130e-02 1.961402353224150e-02 1.961275831461461e-02 1.961149250160691e-02 1.961022609250104e-02 + 1.960895908768241e-02 1.960769148013132e-02 1.960642326897369e-02 1.960515445887448e-02 1.960388504699325e-02 + 1.960261502901453e-02 1.960134440209794e-02 1.960007316755673e-02 1.959880132269796e-02 1.959752885956289e-02 + 1.959625578572781e-02 1.959498210471557e-02 1.959370780282661e-02 1.959243287776576e-02 1.959115733236078e-02 + 1.958988116575855e-02 1.958860437570835e-02 1.958732696070351e-02 1.958604892230215e-02 1.958477025538254e-02 + 1.958349095293616e-02 1.958221102005211e-02 1.958093045820349e-02 1.957964926225915e-02 1.957836742427244e-02 + 1.957708494595253e-02 1.957580183693370e-02 1.957451808573694e-02 1.957323368588814e-02 1.957194864588927e-02 + 1.957066295908808e-02 1.956937661864716e-02 1.956808962863577e-02 1.956680198857452e-02 1.956551369740821e-02 + 1.956422475810978e-02 1.956293516289206e-02 1.956164490198652e-02 1.956035397935251e-02 1.955906239928264e-02 + 1.955777016187055e-02 1.955647725858155e-02 1.955518368630142e-02 1.955388944730695e-02 1.955259453790914e-02 + 1.955129895574477e-02 1.955000270138056e-02 1.954870577278503e-02 1.954740816848287e-02 1.954610988870274e-02 + 1.954481093111385e-02 1.954351129226784e-02 1.954221096901902e-02 1.954090996078360e-02 1.953960826724446e-02 + 1.953830588603245e-02 1.953700281656794e-02 1.953569905855491e-02 1.953439460897686e-02 1.953308946443935e-02 + 1.953178362233442e-02 1.953047708245082e-02 1.952916984426731e-02 1.952786190592496e-02 1.952655326324738e-02 + 1.952524391408689e-02 1.952393385929222e-02 1.952262309949111e-02 1.952131163370209e-02 1.951999945844595e-02 + 1.951868656751035e-02 1.951737295829730e-02 1.951605863555755e-02 1.951474359789877e-02 1.951342784097203e-02 + 1.951211136184995e-02 1.951079415956861e-02 1.950947623396647e-02 1.950815758387342e-02 1.950683820574165e-02 + 1.950551809587482e-02 1.950419725560715e-02 1.950287568354725e-02 1.950155337574423e-02 1.950023033242808e-02 + 1.949890655251627e-02 1.949758203322258e-02 1.949625677745909e-02 1.949493078034667e-02 1.949360402739089e-02 + 1.949227653112452e-02 1.949094829757290e-02 1.948961930480046e-02 1.948828955781861e-02 1.948695906691206e-02 + 1.948562782150981e-02 1.948429581598615e-02 1.948296304982478e-02 1.948162952319633e-02 1.948029523591830e-02 + 1.947896018726217e-02 1.947762437581102e-02 1.947628779922486e-02 1.947495045397724e-02 1.947361233489661e-02 + 1.947227344348770e-02 1.947093378593678e-02 1.946959335022997e-02 1.946825212971076e-02 1.946691013283964e-02 + 1.946556736109183e-02 1.946422381089845e-02 1.946287947598024e-02 1.946153435147304e-02 1.946018843640089e-02 + 1.945884173551620e-02 1.945749424593349e-02 1.945614596164208e-02 1.945479688244431e-02 1.945344700980195e-02 + 1.945209634356683e-02 1.945074487666461e-02 1.944939260492236e-02 1.944803952905332e-02 1.944668565282712e-02 + 1.944533097303948e-02 1.944397548026850e-02 1.944261917903520e-02 1.944126207147254e-02 1.943990414971487e-02 + 1.943854540610747e-02 1.943718584222317e-02 1.943582547177293e-02 1.943446428245481e-02 1.943310226105812e-02 + 1.943173942068859e-02 1.943037575924362e-02 1.942901126749138e-02 1.942764594793762e-02 1.942627979717840e-02 + 1.942491280913776e-02 1.942354498868186e-02 1.942217633546996e-02 1.942080684436220e-02 1.941943651933332e-02 + 1.941806535493775e-02 1.941669333695301e-02 1.941532047644210e-02 1.941394677715704e-02 1.941257222315028e-02 + 1.941119681542690e-02 1.940982056035791e-02 1.940844345901757e-02 1.940706550055424e-02 1.940568667678698e-02 + 1.940430699663802e-02 1.940292645883611e-02 1.940154505765652e-02 1.940016279578962e-02 1.939877966977487e-02 + 1.939739567223053e-02 1.939601080219835e-02 1.939462506233509e-02 1.939323845462366e-02 1.939185096971125e-02 + 1.939046260516801e-02 1.938907336764642e-02 1.938768325184633e-02 1.938629225021856e-02 1.938490035911401e-02 + 1.938350758330235e-02 1.938211392651081e-02 1.938071938447496e-02 1.937932394922459e-02 1.937792761695239e-02 + 1.937653039473651e-02 1.937513227779157e-02 1.937373325789699e-02 1.937233333934693e-02 1.937093252080456e-02 + 1.936953079702195e-02 1.936812816928827e-02 1.936672463690015e-02 1.936532019607867e-02 1.936391484345597e-02 + 1.936250857586552e-02 1.936110139138094e-02 1.935969329410197e-02 1.935828428412852e-02 1.935687435366041e-02 + 1.935546349795341e-02 1.935405171682407e-02 1.935263901452006e-02 1.935122538845629e-02 1.934981083240821e-02 + 1.934839534117787e-02 1.934697891910190e-02 1.934556156924906e-02 1.934414327695751e-02 1.934272404361874e-02 + 1.934130387854031e-02 1.933988276959641e-02 1.933846071416343e-02 1.933703771882020e-02 1.933561377409585e-02 + 1.933418887831357e-02 1.933276303945045e-02 1.933133624375953e-02 1.932990848653697e-02 1.932847978247962e-02 + 1.932705012296452e-02 1.932561949662077e-02 1.932418790536504e-02 1.932275535526071e-02 1.932132184669807e-02 + 1.931988736608416e-02 1.931845191123332e-02 1.931701548648173e-02 1.931557809132799e-02 1.931413972218449e-02 + 1.931270037603072e-02 1.931126005688787e-02 1.930981875761609e-02 1.930837646527647e-02 1.930693319154590e-02 + 1.930548893938918e-02 1.930404369700001e-02 1.930259746628386e-02 1.930115024647330e-02 1.929970202824377e-02 + 1.929825281461415e-02 1.929680260792617e-02 1.929535140092010e-02 1.929389919235001e-02 1.929244598266550e-02 + 1.929099176842190e-02 1.928953654639375e-02 1.928808031414528e-02 1.928662307035359e-02 1.928516481711372e-02 + 1.928370555611205e-02 1.928224527966380e-02 1.928078398206115e-02 1.927932166173262e-02 1.927785831899656e-02 + 1.927639395364510e-02 1.927492856464996e-02 1.927346215243780e-02 1.927199471282116e-02 1.927052623652251e-02 + 1.926905672766994e-02 1.926758618873705e-02 1.926611461056382e-02 1.926464199150991e-02 1.926316833245443e-02 + 1.926169363057714e-02 1.926021788634381e-02 1.925874109903830e-02 1.925726325940621e-02 1.925578436860509e-02 + 1.925430443199749e-02 1.925282343948819e-02 1.925134138889128e-02 1.924985828498051e-02 1.924837411847957e-02 + 1.924688888599618e-02 1.924540259377309e-02 1.924391524090012e-02 1.924242682077230e-02 1.924093732460676e-02 + 1.923944675829762e-02 1.923795512510602e-02 1.923646241448938e-02 1.923496862521413e-02 1.923347375911634e-02 + 1.923197781292445e-02 1.923048078180134e-02 1.922898266296426e-02 1.922748346006174e-02 1.922598317069195e-02 + 1.922448178990142e-02 1.922297932164773e-02 1.922147575963824e-02 1.921997109174737e-02 1.921846532805457e-02 + 1.921695846861228e-02 1.921545049993734e-02 1.921394143207274e-02 1.921243126559395e-02 1.921091998083786e-02 + 1.920940758472120e-02 1.920789408374423e-02 1.920637946562360e-02 1.920486373146851e-02 1.920334688393281e-02 + 1.920182891329169e-02 1.920030981699324e-02 1.919878959725658e-02 1.919726825432456e-02 1.919574578635056e-02 + 1.919422218928470e-02 1.919269745661605e-02 1.919117158884151e-02 1.918964459045353e-02 1.918811645370936e-02 + 1.918658717454346e-02 1.918505675553962e-02 1.918352519296369e-02 1.918199248296462e-02 1.918045862469436e-02 + 1.917892361805418e-02 1.917738746182788e-02 1.917585015265352e-02 1.917431168820606e-02 1.917277206550804e-02 + 1.917123127946213e-02 1.916968933132487e-02 1.916814622316750e-02 1.916660194885779e-02 1.916505650873668e-02 + 1.916350990423480e-02 1.916196212155291e-02 1.916041316033273e-02 1.915886303062994e-02 1.915731172194125e-02 + 1.915575922930148e-02 1.915420555876758e-02 1.915265070860661e-02 1.915109467332810e-02 1.914953744666585e-02 + 1.914797902645569e-02 1.914641941412443e-02 1.914485861314037e-02 1.914329661713828e-02 1.914173341932142e-02 + 1.914016902223032e-02 1.913860342379879e-02 1.913703662029905e-02 1.913546861279183e-02 1.913389939805644e-02 + 1.913232897075573e-02 1.913075733118505e-02 1.912918447844714e-02 1.912761040908805e-02 1.912603511839811e-02 + 1.912445860715432e-02 1.912288088009771e-02 1.912130192853472e-02 1.911972174626816e-02 1.911814033569584e-02 + 1.911655769224527e-02 1.911497381452394e-02 1.911338870990516e-02 1.911180236957772e-02 1.911021478317005e-02 + 1.910862595492130e-02 1.910703588697045e-02 1.910544457683553e-02 1.910385201685182e-02 1.910225820527016e-02 + 1.910066314375077e-02 1.909906682830796e-02 1.909746925477876e-02 1.909587042200599e-02 1.909427033688354e-02 + 1.909266899402551e-02 1.909106637643193e-02 1.908946249114346e-02 1.908785734491775e-02 1.908625093213804e-02 + 1.908464324204344e-02 1.908303427175084e-02 1.908142403234494e-02 1.907981251534393e-02 1.907819971100440e-02 + 1.907658562789714e-02 1.907497026158614e-02 1.907335360333112e-02 1.907173565762024e-02 1.907011642370295e-02 + 1.906849589616872e-02 1.906687407274958e-02 1.906525095073851e-02 1.906362652703246e-02 1.906200080112851e-02 + 1.906037377260159e-02 1.905874543999789e-02 1.905711580005939e-02 1.905548484883143e-02 1.905385258297056e-02 + 1.905221900422594e-02 1.905058411108648e-02 1.904894789413228e-02 1.904731035325132e-02 1.904567149183364e-02 + 1.904403130952197e-02 1.904238980136186e-02 1.904074696113758e-02 1.903910278612417e-02 1.903745727544392e-02 + 1.903581042868199e-02 1.903416224385271e-02 1.903251272055347e-02 1.903086185871027e-02 1.902920965236104e-02 + 1.902755609551852e-02 1.902590118543579e-02 1.902424492713456e-02 1.902258731926820e-02 1.902092835050054e-02 + 1.901926802409253e-02 1.901760634215130e-02 1.901594329530476e-02 1.901427888303375e-02 1.901261310655987e-02 + 1.901094596056572e-02 1.900927744335199e-02 1.900760755425454e-02 1.900593628837979e-02 1.900426364429972e-02 + 1.900258962310978e-02 1.900091422355684e-02 1.899923743835855e-02 1.899755925950979e-02 1.899587969656637e-02 + 1.899419874741247e-02 1.899251639645128e-02 1.899083265299966e-02 1.898914752052511e-02 1.898746098477085e-02 + 1.898577304386013e-02 1.898408369969058e-02 1.898239295076986e-02 1.898070079269564e-02 1.897900722255288e-02 + 1.897731224261929e-02 1.897561584849886e-02 1.897391803334516e-02 1.897221879605241e-02 1.897051814026927e-02 + 1.896881606767167e-02 1.896711256470153e-02 1.896540762798833e-02 1.896370126437186e-02 1.896199347193909e-02 + 1.896028424413336e-02 1.895857357350164e-02 1.895686146124061e-02 1.895514791045918e-02 1.895343292131205e-02 + 1.895171648302300e-02 1.894999858923527e-02 1.894827924721451e-02 1.894655845419708e-02 1.894483620522033e-02 + 1.894311250187257e-02 1.894138733732357e-02 1.893966070463249e-02 1.893793261072514e-02 1.893620305335951e-02 + 1.893447202418282e-02 1.893273952309081e-02 1.893100555094376e-02 1.892927010627177e-02 1.892753318110494e-02 + 1.892579477108063e-02 1.892405487784487e-02 1.892231350329449e-02 1.892057064453369e-02 1.891882629307712e-02 + 1.891708044683251e-02 1.891533310610873e-02 1.891358427035544e-02 1.891183393696100e-02 1.891008210291091e-02 + 1.890832876617924e-02 1.890657392211156e-02 1.890481756749361e-02 1.890305970669826e-02 1.890130033664154e-02 + 1.889953944876527e-02 1.889777703845312e-02 1.889601310905792e-02 1.889424766560776e-02 1.889248069356991e-02 + 1.889071219005931e-02 1.888894216610460e-02 1.888717060771540e-02 1.888539750970531e-02 1.888362288621832e-02 + 1.888184672351093e-02 1.888006901097801e-02 1.887828976119468e-02 1.887650896887177e-02 1.887472662448569e-02 + 1.887294273026847e-02 1.887115728373587e-02 1.886937028132879e-02 1.886758172601296e-02 1.886579161241305e-02 + 1.886399993232671e-02 1.886220669095003e-02 1.886041188581822e-02 1.885861550746470e-02 1.885681755698847e-02 + 1.885501803485419e-02 1.885321693733238e-02 1.885141425906957e-02 1.884960999916156e-02 1.884780416185130e-02 + 1.884599674103886e-02 1.884418772927479e-02 1.884237712445391e-02 1.884056492700234e-02 1.883875113673901e-02 + 1.883693574995443e-02 1.883511876102816e-02 1.883330016667216e-02 1.883147997149076e-02 1.882965817385698e-02 + 1.882783476601560e-02 1.882600973926643e-02 1.882418309568715e-02 1.882235484340025e-02 1.882052497417560e-02 + 1.881869348031539e-02 1.881686035975185e-02 1.881502561164409e-02 1.881318923741505e-02 1.881135123913003e-02 + 1.880951160558249e-02 1.880767032900146e-02 1.880582741534564e-02 1.880398286136111e-02 1.880213666245483e-02 + 1.880028882149621e-02 1.879843933370182e-02 1.879658819228311e-02 1.879473539862031e-02 1.879288094991765e-02 + 1.879102484097325e-02 1.878916707209326e-02 1.878730764191372e-02 1.878544654683108e-02 1.878358378459472e-02 + 1.878171935183507e-02 1.877985324430765e-02 1.877798546179407e-02 1.877611600228067e-02 1.877424486050507e-02 + 1.877237203778229e-02 1.877049753324887e-02 1.876862133863330e-02 1.876674345293673e-02 1.876486387617420e-02 + 1.876298260257535e-02 1.876109963059111e-02 1.875921496034764e-02 1.875732858848502e-02 1.875544051216185e-02 + 1.875355072885378e-02 1.875165923449702e-02 1.874976602623304e-02 1.874787110336161e-02 1.874597446797304e-02 + 1.874407611425766e-02 1.874217603022874e-02 1.874027422146802e-02 1.873837068906284e-02 1.873646542198345e-02 + 1.873455842189881e-02 1.873264969164939e-02 1.873073922656172e-02 1.872882701964194e-02 1.872691306648714e-02 + 1.872499736923527e-02 1.872307992509612e-02 1.872116072949887e-02 1.871923978227258e-02 1.871731708186487e-02 + 1.871539262387551e-02 1.871346640021372e-02 1.871153841041527e-02 1.870960865979342e-02 1.870767714578883e-02 + 1.870574386089293e-02 1.870380879685916e-02 1.870187195798613e-02 1.869993334446320e-02 1.869799294696750e-02 + 1.869605076691687e-02 1.869410680376838e-02 1.869216104730458e-02 1.869021349836844e-02 1.868826416022470e-02 + 1.868631302853863e-02 1.868436009644664e-02 1.868240535897862e-02 1.868044881818047e-02 1.867849047172725e-02 + 1.867653031474529e-02 1.867456834731333e-02 1.867260456736053e-02 1.867063897034608e-02 1.866867155351236e-02 + 1.866670231459311e-02 1.866473125095620e-02 1.866275835809391e-02 1.866078363356833e-02 1.865880707775009e-02 + 1.865682868564128e-02 1.865484845476688e-02 1.865286638889887e-02 1.865088247751579e-02 1.864889671303901e-02 + 1.864690910747520e-02 1.864491965354244e-02 1.864292833855512e-02 1.864093516946379e-02 1.863894014384585e-02 + 1.863694325319922e-02 1.863494449952898e-02 1.863294388193027e-02 1.863094139526787e-02 1.862893703607748e-02 + 1.862693080034535e-02 1.862492268387857e-02 1.862291268732941e-02 1.862090081042848e-02 1.861888704957227e-02 + 1.861687140151818e-02 1.861485386231105e-02 1.861283442704270e-02 1.861081309610335e-02 1.860878986806025e-02 + 1.860676473338590e-02 1.860473769529663e-02 1.860270875778476e-02 1.860067790615180e-02 1.859864513789995e-02 + 1.859661045850656e-02 1.859457386260990e-02 1.859253534675110e-02 1.859049490946049e-02 1.858845254228221e-02 + 1.858640824383296e-02 1.858436201966219e-02 1.858231386031445e-02 1.858026376148910e-02 1.857821173011040e-02 + 1.857615775674864e-02 1.857410183289329e-02 1.857204396224591e-02 1.856998414158087e-02 1.856792236630606e-02 + 1.856585863699762e-02 1.856379295088432e-02 1.856172530348682e-02 1.855965569223371e-02 1.855758411493529e-02 + 1.855551056872843e-02 1.855343504862798e-02 1.855135755357239e-02 1.854927808391809e-02 1.854719662999937e-02 + 1.854511318947389e-02 1.854302776884543e-02 1.854094036342127e-02 1.853885096469986e-02 1.853675956540365e-02 + 1.853466616668727e-02 1.853257077183708e-02 1.853047338096206e-02 1.852837398473379e-02 1.852627257507170e-02 + 1.852416915520061e-02 1.852206372211816e-02 1.851995627104085e-02 1.851784680396669e-02 1.851573531468755e-02 + 1.851362179508880e-02 1.851150625260910e-02 1.850938868433302e-02 1.850726907790290e-02 1.850514743267316e-02 + 1.850302375022463e-02 1.850089802974987e-02 1.849877026321467e-02 1.849664044568886e-02 1.849450857919205e-02 + 1.849237466328984e-02 1.849023869225825e-02 1.848810065567833e-02 1.848596056072587e-02 1.848381841125062e-02 + 1.848167418759208e-02 1.847952788817062e-02 1.847737952020788e-02 1.847522908039946e-02 1.847307656165976e-02 + 1.847092195736722e-02 1.846876526733367e-02 1.846660649126623e-02 1.846444562782898e-02 1.846228267641075e-02 + 1.846011763022634e-02 1.845795047822359e-02 1.845578122357826e-02 1.845360986824314e-02 1.845143640646702e-02 + 1.844926083412144e-02 1.844708314829677e-02 1.844490334652741e-02 1.844272142526039e-02 1.844053738232335e-02 + 1.843835121884711e-02 1.843616292877729e-02 1.843397250473794e-02 1.843177994759022e-02 1.842958525561723e-02 + 1.842738842512387e-02 1.842518945510765e-02 1.842298833954339e-02 1.842078507029563e-02 1.841857965103055e-02 + 1.841637208298309e-02 1.841416236088061e-02 1.841195047731196e-02 1.840973642948215e-02 1.840752022011446e-02 + 1.840530184216091e-02 1.840308128892246e-02 1.840085856103635e-02 1.839863365911139e-02 1.839640658087383e-02 + 1.839417731924000e-02 1.839194587083986e-02 1.838971223370895e-02 1.838747640300020e-02 1.838523837692452e-02 + 1.838299815548432e-02 1.838075573582631e-02 1.837851111106092e-02 1.837626427462707e-02 1.837401523350234e-02 + 1.837176398539980e-02 1.836951051641877e-02 1.836725482529124e-02 1.836499691387402e-02 1.836273678151691e-02 + 1.836047442118306e-02 1.835820982858270e-02 1.835594300692513e-02 1.835367394977665e-02 1.835140264983480e-02 + 1.834912910825698e-02 1.834685332362546e-02 1.834457529066184e-02 1.834229500068380e-02 1.834001245612868e-02 + 1.833772766191195e-02 1.833544060380268e-02 1.833315127769170e-02 1.833085968975407e-02 1.832856583633842e-02 + 1.832626971106521e-02 1.832397130817964e-02 1.832167062581619e-02 1.831936766045366e-02 1.831706240632338e-02 + 1.831475486820015e-02 1.831244504576387e-02 1.831013292472488e-02 1.830781850356614e-02 1.830550178468002e-02 + 1.830318276421879e-02 1.830086143845657e-02 1.829853780375753e-02 1.829621185558813e-02 1.829388359300937e-02 + 1.829155301569956e-02 1.828922011662799e-02 1.828688489153528e-02 1.828454733892483e-02 1.828220745351499e-02 + 1.827986523367206e-02 1.827752068069898e-02 1.827517378500067e-02 1.827282454323407e-02 1.827047296291425e-02 + 1.826811903643735e-02 1.826576275326505e-02 1.826340410954280e-02 1.826104310998728e-02 1.825867975496676e-02 + 1.825631402943589e-02 1.825394593365713e-02 1.825157547349511e-02 1.824920264235266e-02 1.824682743095013e-02 + 1.824444983334214e-02 1.824206985531418e-02 1.823968749396920e-02 1.823730273947125e-02 1.823491559405069e-02 + 1.823252605635143e-02 1.823013411851380e-02 1.822773977727079e-02 1.822534302885856e-02 1.822294386817581e-02 + 1.822054229933361e-02 1.821813832218229e-02 1.821573192447362e-02 1.821332310276354e-02 1.821091185568656e-02 + 1.820849817689734e-02 1.820608206836350e-02 1.820366353310689e-02 1.820124256311412e-02 1.819881915016099e-02 + 1.819639328969794e-02 1.819396498477247e-02 1.819153423068764e-02 1.818910101812068e-02 1.818666535246774e-02 + 1.818422723286477e-02 1.818178664914423e-02 1.817934360000525e-02 1.817689808189780e-02 1.817445008627356e-02 + 1.817199961756547e-02 1.816954667558178e-02 1.816709124568389e-02 1.816463332917677e-02 1.816217292950077e-02 + 1.815971003769815e-02 1.815724465123547e-02 1.815477676809149e-02 1.815230637650250e-02 1.814983348051392e-02 + 1.814735808823705e-02 1.814488018072306e-02 1.814239975267995e-02 1.813991681262074e-02 1.813743135508509e-02 + 1.813494337086823e-02 1.813245285281114e-02 1.812995980445686e-02 1.812746422731492e-02 1.812496611573551e-02 + 1.812246546481565e-02 1.811996226848969e-02 1.811745651920204e-02 1.811494821957559e-02 1.811243737133842e-02 + 1.810992396481434e-02 1.810740799805441e-02 1.810488947142559e-02 1.810236837745802e-02 1.809984471224923e-02 + 1.809731847419077e-02 1.809478965788605e-02 1.809225826197647e-02 1.808972428730369e-02 1.808718772623545e-02 + 1.808464857219165e-02 1.808210682315950e-02 1.807956248210254e-02 1.807701554512131e-02 1.807446599893149e-02 + 1.807191384222250e-02 1.806935907649996e-02 1.806680169977935e-02 1.806424171112906e-02 1.806167910639137e-02 + 1.805911387430984e-02 1.805654601234490e-02 1.805397552118165e-02 1.805140239539148e-02 1.804882663464111e-02 + 1.804624823872755e-02 1.804366719439020e-02 1.804108350087335e-02 1.803849716547347e-02 1.803590817366155e-02 + 1.803331652090480e-02 1.803072221546651e-02 1.802812524400898e-02 1.802552559998909e-02 1.802292329257977e-02 + 1.802031831251088e-02 1.801771065083283e-02 1.801510031065072e-02 1.801248728509480e-02 1.800987156794499e-02 + 1.800725316456288e-02 1.800463207196059e-02 1.800200828229563e-02 1.799938179038418e-02 1.799675259135415e-02 + 1.799412068157979e-02 1.799148606152016e-02 1.798884872978088e-02 1.798620868169797e-02 1.798356590941466e-02 + 1.798092041139825e-02 1.797827219073602e-02 1.797562123473000e-02 1.797296753674024e-02 1.797031110360818e-02 + 1.796765193280976e-02 1.796499001786419e-02 1.796232535287627e-02 1.795965793501132e-02 1.795698776183851e-02 + 1.795431482887613e-02 1.795163913285315e-02 1.794896067070983e-02 1.794627943785036e-02 1.794359543174794e-02 + 1.794090865000600e-02 1.793821908548673e-02 1.793552673496832e-02 1.793283159877326e-02 1.793013367385930e-02 + 1.792743295577707e-02 1.792472944026945e-02 1.792202312682011e-02 1.791931400976357e-02 1.791660207728341e-02 + 1.791388733234035e-02 1.791116977642004e-02 1.790844939977351e-02 1.790572620127331e-02 1.790300018053203e-02 + 1.790027132960331e-02 1.789753964610457e-02 1.789480512776976e-02 1.789206776371137e-02 1.788932755546883e-02 + 1.788658450796398e-02 1.788383860557862e-02 1.788108984645815e-02 1.787833823870088e-02 1.787558376650758e-02 + 1.787282642238153e-02 1.787006621288861e-02 1.786730313584615e-02 1.786453718506033e-02 1.786176835331611e-02 + 1.785899663566110e-02 1.785622203220682e-02 1.785344454733639e-02 1.785066416506327e-02 1.784788087479271e-02 + 1.784509469481547e-02 1.784230561688990e-02 1.783951362363962e-02 1.783671871969004e-02 1.783392090351773e-02 + 1.783112016693977e-02 1.782831650359620e-02 1.782550991644932e-02 1.782270041052123e-02 1.781988796773664e-02 + 1.781707258188517e-02 1.781425426228424e-02 1.781143299909701e-02 1.780860878344276e-02 1.780578161636334e-02 + 1.780295150019453e-02 1.780011843142990e-02 1.779728239750767e-02 1.779444339320670e-02 1.779160141853593e-02 + 1.778875647528820e-02 1.778590855799184e-02 1.778305765851556e-02 1.778020377358821e-02 1.777734690358035e-02 + 1.777448704738365e-02 1.777162419310320e-02 1.776875833746895e-02 1.776588948369731e-02 1.776301762263940e-02 + 1.776014274927566e-02 1.775726486578331e-02 1.775438397030816e-02 1.775150005486545e-02 1.774861310790110e-02 + 1.774572313526677e-02 1.774283013776283e-02 1.773993409898065e-02 1.773703502220879e-02 1.773413291089222e-02 + 1.773122774923129e-02 1.772831953604024e-02 1.772540827370780e-02 1.772249394894422e-02 1.771957656009896e-02 + 1.771665611194296e-02 1.771373259698992e-02 1.771080600888477e-02 1.770787634473108e-02 1.770494360249459e-02 + 1.770200777818149e-02 1.769906886558849e-02 1.769612685929023e-02 1.769318175770428e-02 1.769023356261796e-02 + 1.768728226707501e-02 1.768432786370409e-02 1.768137035050212e-02 1.767840972761326e-02 1.767544598996190e-02 + 1.767247912224100e-02 1.766950912887429e-02 1.766653601772543e-02 1.766355977437013e-02 1.766058039164660e-02 + 1.765759786981226e-02 1.765461220736955e-02 1.765162339764906e-02 1.764863143247870e-02 1.764563631444012e-02 + 1.764263804044564e-02 1.763963660052613e-02 1.763663199590508e-02 1.763362422648862e-02 1.763061328532627e-02 + 1.762759916389677e-02 1.762458185742205e-02 1.762156136756127e-02 1.761853769290762e-02 1.761551082691653e-02 + 1.761248075761478e-02 1.760944748669641e-02 1.760641101894919e-02 1.760337134551661e-02 1.760032845807722e-02 + 1.759728235211478e-02 1.759423302856655e-02 1.759118048266074e-02 1.758812470690578e-02 1.758506570645847e-02 + 1.758200347417691e-02 1.757893799151254e-02 1.757586926700291e-02 1.757279730534286e-02 1.756972209521438e-02 + 1.756664362962799e-02 1.756356190543487e-02 1.756047692143249e-02 1.755738866974527e-02 1.755429714394244e-02 + 1.755120234663686e-02 1.754810427470094e-02 1.754500292288027e-02 1.754189829041229e-02 1.753879037098419e-02 + 1.753567915477636e-02 1.753256463576890e-02 1.752944681640228e-02 1.752632570156945e-02 1.752320127895599e-02 + 1.752007354011609e-02 1.751694248500407e-02 1.751380811099548e-02 1.751067041466748e-02 1.750752939229762e-02 + 1.750438503712632e-02 1.750123734468025e-02 1.749808631552286e-02 1.749493194526630e-02 1.749177422703599e-02 + 1.748861315463852e-02 1.748544872591071e-02 1.748228094036503e-02 1.747910979560325e-02 1.747593528635296e-02 + 1.747275740493088e-02 1.746957614261004e-02 1.746639150171011e-02 1.746320348827029e-02 1.746001208402579e-02 + 1.745681728232032e-02 1.745361909228664e-02 1.745041750587895e-02 1.744721251527593e-02 1.744400411995098e-02 + 1.744079231626219e-02 1.743757709612158e-02 1.743435844889677e-02 1.743113638300998e-02 1.742791090294012e-02 + 1.742468198827393e-02 1.742144963687445e-02 1.741821385208018e-02 1.741497462017237e-02 1.741173194001650e-02 + 1.740848581625378e-02 1.740523623716524e-02 1.740198319673262e-02 1.739872669626729e-02 1.739546673433575e-02 + 1.739220330474240e-02 1.738893639777237e-02 1.738566600801745e-02 1.738239213410604e-02 1.737911477739739e-02 + 1.737583393441487e-02 1.737254959973500e-02 1.736926176792087e-02 1.736597043319887e-02 1.736267559029083e-02 + 1.735937723525189e-02 1.735607536431420e-02 1.735276997535949e-02 1.734946106967137e-02 1.734614863942214e-02 + 1.734283267462293e-02 1.733951317984790e-02 1.733619014933173e-02 1.733286356952035e-02 1.732953344236944e-02 + 1.732619976822115e-02 1.732286254123125e-02 1.731952175476255e-02 1.731617740506982e-02 1.731282949118149e-02 + 1.730947800429541e-02 1.730612293897103e-02 1.730276429900506e-02 1.729940207772190e-02 1.729603626710180e-02 + 1.729266686687025e-02 1.728929387127552e-02 1.728591727431661e-02 1.728253707811547e-02 1.727915327486350e-02 + 1.727576585445017e-02 1.727237482415143e-02 1.726898017713387e-02 1.726558189725253e-02 1.726217999255776e-02 + 1.725877446141184e-02 1.725536528836806e-02 1.725195247427305e-02 1.724853602088567e-02 1.724511592318061e-02 + 1.724169217016580e-02 1.723826475637563e-02 1.723483368674653e-02 1.723139894995541e-02 1.722796053633534e-02 + 1.722451845482723e-02 1.722107270070567e-02 1.721762326419149e-02 1.721417014587169e-02 1.721071333868621e-02 + 1.720725283251134e-02 1.720378862838028e-02 1.720032072298445e-02 1.719684910908383e-02 1.719337378669194e-02 + 1.718989475327181e-02 1.718641200187306e-02 1.718292552719872e-02 1.717943532374793e-02 1.717594138625576e-02 + 1.717244371734551e-02 1.716894231509765e-02 1.716543716617480e-02 1.716192826455456e-02 1.715841561099909e-02 + 1.715489920993168e-02 1.715137904713604e-02 1.714785510917266e-02 1.714432741097788e-02 1.714079594608009e-02 + 1.713726069602739e-02 1.713372166332687e-02 1.713017885016558e-02 1.712663225240283e-02 1.712308185705881e-02 + 1.711952765873538e-02 1.711596966109396e-02 1.711240786053498e-02 1.710884225051524e-02 1.710527282476134e-02 + 1.710169958307061e-02 1.709812252022495e-02 1.709454162136748e-02 1.709095688985418e-02 1.708736832996113e-02 + 1.708377593024533e-02 1.708017968752960e-02 1.707657960032946e-02 1.707297565703870e-02 1.706936785401023e-02 + 1.706575619189593e-02 1.706214066346443e-02 1.705852126552140e-02 1.705489799818787e-02 1.705127085519305e-02 + 1.704763983091843e-02 1.704400492089210e-02 1.704036611449886e-02 1.703672340943711e-02 1.703307681394708e-02 + 1.702942631772786e-02 1.702577190966809e-02 1.702211358937508e-02 1.701845135582294e-02 1.701478520463906e-02 + 1.701111512687454e-02 1.700744111902223e-02 1.700376317991698e-02 1.700008130526762e-02 1.699639548886451e-02 + 1.699270572517141e-02 1.698901201362202e-02 1.698531434790372e-02 1.698161271901581e-02 1.697790713038581e-02 + 1.697419757947398e-02 1.697048405591379e-02 1.696676655885514e-02 1.696304508413142e-02 1.695931962055792e-02 + 1.695559016575875e-02 1.695185672007940e-02 1.694811928170539e-02 1.694437784303563e-02 1.694063239701608e-02 + 1.693688294268234e-02 1.693312947555357e-02 1.692937198914621e-02 1.692561047849961e-02 1.692184494218333e-02 + 1.691807537819241e-02 1.691430177590003e-02 1.691052413380094e-02 1.690674245501956e-02 1.690295672392027e-02 + 1.689916693403359e-02 1.689537309141036e-02 1.689157519031890e-02 1.688777322481082e-02 1.688396719247375e-02 + 1.688015708323470e-02 1.687634289028026e-02 1.687252461641300e-02 1.686870225976892e-02 1.686487581335405e-02 + 1.686104526641643e-02 1.685721061978611e-02 1.685337187596560e-02 1.684952902423863e-02 1.684568205626177e-02 + 1.684183096806695e-02 1.683797575916921e-02 1.683411642637722e-02 1.683025296370582e-02 1.682638536598722e-02 + 1.682251363071521e-02 1.681863775630957e-02 1.681475773295268e-02 1.681087355358095e-02 1.680698521822956e-02 + 1.680309272743823e-02 1.679919607564722e-02 1.679529524908240e-02 1.679139024683375e-02 1.678748107079098e-02 + 1.678356771499038e-02 1.677965016895157e-02 1.677572842703558e-02 1.677180249929987e-02 1.676787237703614e-02 + 1.676393804299063e-02 1.675999950051788e-02 1.675605674951069e-02 1.675210978219402e-02 1.674815858725950e-02 + 1.674420316518524e-02 1.674024352454331e-02 1.673627964747038e-02 1.673231152527195e-02 1.672833916857912e-02 + 1.672436256552257e-02 1.672038170373856e-02 1.671639658470834e-02 1.671240720840105e-02 1.670841357063555e-02 + 1.670441566220705e-02 1.670041347959014e-02 1.669640702110204e-02 1.669239628051189e-02 1.668838125191250e-02 + 1.668436193143650e-02 1.668033831890629e-02 1.667631040878886e-02 1.667227819212758e-02 1.666824166734860e-02 + 1.666420083129591e-02 1.666015567735254e-02 1.665610620005455e-02 1.665205239678242e-02 1.664799426695549e-02 + 1.664393180284348e-02 1.663986499713315e-02 1.663579384792829e-02 1.663171835503466e-02 1.662763851356003e-02 + 1.662355430939835e-02 1.661946574092143e-02 1.661537281150426e-02 1.661127551677910e-02 1.660717384720702e-02 + 1.660306779425839e-02 1.659895736095696e-02 1.659484254425630e-02 1.659072333444665e-02 1.658659972465595e-02 + 1.658247171530552e-02 1.657833931027815e-02 1.657420249617699e-02 1.657006126301349e-02 1.656591561144095e-02 + 1.656176553662080e-02 1.655761103381663e-02 1.655345210211223e-02 1.654928873901935e-02 1.654512093811135e-02 + 1.654094868807454e-02 1.653677198858015e-02 1.653259084096055e-02 1.652840523447503e-02 1.652421516561530e-02 + 1.652002063436291e-02 1.651582163151349e-02 1.651161815099949e-02 1.650741019156900e-02 1.650319775344297e-02 + 1.649898082810461e-02 1.649475940168675e-02 1.649053348141889e-02 1.648630306850305e-02 1.648206814836095e-02 + 1.647782871114676e-02 1.647358475732917e-02 1.646933629656457e-02 1.646508330893651e-02 1.646082578033714e-02 + 1.645656373337251e-02 1.645229715576629e-02 1.644802602626009e-02 1.644375035674409e-02 1.643947014097659e-02 + 1.643518536281393e-02 1.643089602671802e-02 1.642660213310334e-02 1.642230367492405e-02 1.641800064388943e-02 + 1.641369303446324e-02 1.640938084474308e-02 1.640506407467653e-02 1.640074271742540e-02 1.639641675907646e-02 + 1.639208620097271e-02 1.638775104513307e-02 1.638341128505268e-02 1.637906691499287e-02 1.637471792980197e-02 + 1.637036432400064e-02 1.636600609175647e-02 1.636164322915392e-02 1.635727573684415e-02 1.635290360792794e-02 + 1.634852683359730e-02 1.634414541697593e-02 1.633975935494602e-02 1.633536863669590e-02 1.633097325119221e-02 + 1.632657319870386e-02 1.632216848742881e-02 1.631775910539292e-02 1.631334504210032e-02 1.630892629731235e-02 + 1.630450287107613e-02 1.630007475715268e-02 1.629564194133085e-02 1.629120442381021e-02 1.628676220752001e-02 + 1.628231528645751e-02 1.627786365361661e-02 1.627340730437480e-02 1.626894623909321e-02 1.626448044809207e-02 + 1.626000991935131e-02 1.625553465710418e-02 1.625105466086324e-02 1.624656992364918e-02 1.624208044008659e-02 + 1.623758620493278e-02 1.623308721259990e-02 1.622858345750622e-02 1.622407493651434e-02 1.621956164908100e-02 + 1.621504359102545e-02 1.621052075671857e-02 1.620599314061202e-02 1.620146073758967e-02 1.619692354185834e-02 + 1.619238154678624e-02 1.618783475477294e-02 1.618328316706134e-02 1.617872676957040e-02 1.617416555535298e-02 + 1.616959952441603e-02 1.616502867670949e-02 1.616045300241566e-02 1.615587248863419e-02 1.615128714307292e-02 + 1.614669696726644e-02 1.614210195036420e-02 1.613750207990814e-02 1.613289735436475e-02 1.612828778261194e-02 + 1.612367334765880e-02 1.611905403879705e-02 1.611442986870223e-02 1.610980082722066e-02 1.610516690212456e-02 + 1.610052809916244e-02 1.609588441136000e-02 1.609123582829610e-02 1.608658235171540e-02 1.608192397521171e-02 + 1.607726068992654e-02 1.607259250083978e-02 1.606791940362701e-02 1.606324138657220e-02 1.605855844962495e-02 + 1.605387058768025e-02 1.604917779011535e-02 1.604448006054786e-02 1.603977739874237e-02 1.603506979420087e-02 + 1.603035723984084e-02 1.602563973257448e-02 1.602091727188371e-02 1.601618984720332e-02 1.601145745295015e-02 + 1.600672010067149e-02 1.600197777942985e-02 1.599723047266619e-02 1.599247818462375e-02 1.598772091449355e-02 + 1.598295865408641e-02 1.597819139147786e-02 1.597341912912636e-02 1.596864187530068e-02 1.596385961058315e-02 + 1.595907232771693e-02 1.595428003613896e-02 1.594948272828454e-02 1.594468039178993e-02 1.593987301780130e-02 + 1.593506061365002e-02 1.593024318102167e-02 1.592542070422077e-02 1.592059317798925e-02 1.591576060279083e-02 + 1.591092297799217e-02 1.590608029141302e-02 1.590123253274349e-02 1.589637971157846e-02 1.589152182656434e-02 + 1.588665886609507e-02 1.588179081847464e-02 1.587691768450550e-02 1.587203947045915e-02 1.586715616213467e-02 + 1.586226775168990e-02 1.585737424168921e-02 1.585247562649581e-02 1.584757190117160e-02 1.584266306445842e-02 + 1.583774911091078e-02 1.583283003450806e-02 1.582790583090947e-02 1.582297649499978e-02 1.581804202355953e-02 + 1.581310241701619e-02 1.580815766650671e-02 1.580320776320766e-02 1.579825271139450e-02 1.579329250537274e-02 + 1.578832713506978e-02 1.578335660262603e-02 1.577838090296324e-02 1.577340002574811e-02 1.576841397243399e-02 + 1.576342274326813e-02 1.575842633194578e-02 1.575342472205075e-02 1.574841791148685e-02 1.574340591569888e-02 + 1.573838872006093e-02 1.573336631006632e-02 1.572833869008299e-02 1.572330586230670e-02 1.571826781924578e-02 + 1.571322454052314e-02 1.570817603062760e-02 1.570312230059812e-02 1.569806333998715e-02 1.569299913693516e-02 + 1.568792968457186e-02 1.568285498663007e-02 1.567777503779379e-02 1.567268982728102e-02 1.566759935997030e-02 + 1.566250363482262e-02 1.565740264102256e-02 1.565229637077196e-02 1.564718482295817e-02 1.564206800099241e-02 + 1.563694589151567e-02 1.563181848599405e-02 1.562668579194260e-02 1.562154780177149e-02 1.561640450642917e-02 + 1.561125590888111e-02 1.560610200797837e-02 1.560094279515962e-02 1.559577825343192e-02 1.559060838842812e-02 + 1.558543321151646e-02 1.558025270088283e-02 1.557506685188879e-02 1.556987567405825e-02 1.556467915294808e-02 + 1.555947727806998e-02 1.555427005014520e-02 1.554905747326830e-02 1.554383954557267e-02 1.553861625685508e-02 + 1.553338760005679e-02 1.552815357203842e-02 1.552291417232042e-02 1.551766939022104e-02 1.551241921985975e-02 + 1.550716367246923e-02 1.550190274051892e-02 1.549663640983429e-02 1.549136467943576e-02 1.548608754911306e-02 + 1.548080501516420e-02 1.547551706650131e-02 1.547022370107663e-02 1.546492492363977e-02 1.545962073006300e-02 + 1.545431111106912e-02 1.544899605692932e-02 1.544367557060635e-02 1.543834964941066e-02 1.543301828099291e-02 + 1.542768146907574e-02 1.542233921474585e-02 1.541699150599057e-02 1.541163833967913e-02 1.540627971422265e-02 + 1.540091562222576e-02 1.539554606062004e-02 1.539017102808156e-02 1.538479052048013e-02 1.537940453376258e-02 + 1.537401306270197e-02 1.536861609811398e-02 1.536321364249661e-02 1.535780570199338e-02 1.535239225620149e-02 + 1.534697329939463e-02 1.534154884369051e-02 1.533611887960563e-02 1.533068339829330e-02 1.532524239983298e-02 + 1.531979587995433e-02 1.531434383110085e-02 1.530888624554550e-02 1.530342313142362e-02 1.529795449144603e-02 + 1.529248030485156e-02 1.528700056732233e-02 1.528151528324413e-02 1.527602445059826e-02 1.527052806021316e-02 + 1.526502610370102e-02 1.525951858764995e-02 1.525400550804322e-02 1.524848685322667e-02 1.524296262660809e-02 + 1.523743282528689e-02 1.523189743753784e-02 1.522635646012132e-02 1.522080989370855e-02 1.521525773883866e-02 + 1.520969998584297e-02 1.520413662809972e-02 1.519856766896251e-02 1.519299310438481e-02 1.518741292689401e-02 + 1.518182713051541e-02 1.517623571498702e-02 1.517063867977171e-02 1.516503601659771e-02 1.515942772580205e-02 + 1.515381380882217e-02 1.514819425008754e-02 1.514256904339338e-02 1.513693819284546e-02 1.513130169987854e-02 + 1.512565955837021e-02 1.512001175774349e-02 1.511435830052952e-02 1.510869918485496e-02 1.510303439909880e-02 + 1.509736393861015e-02 1.509168780464220e-02 1.508600600178219e-02 1.508031852355242e-02 1.507462535986425e-02 + 1.506892650464710e-02 1.506322195838325e-02 1.505751172137055e-02 1.505179578553525e-02 1.504607414992266e-02 + 1.504034681527993e-02 1.503461377008154e-02 1.502887501067205e-02 1.502313053999477e-02 1.501738035243006e-02 + 1.501162444030474e-02 1.500586279803602e-02 1.500009542963074e-02 1.499432233574762e-02 1.498854350912934e-02 + 1.498275894315130e-02 1.497696863387312e-02 1.497117258012378e-02 1.496537077480856e-02 1.495956321394884e-02 + 1.495374990400090e-02 1.494793083920974e-02 1.494210600904758e-02 1.493627541059610e-02 1.493043904648383e-02 + 1.492459691659297e-02 1.491874900408085e-02 1.491289530722370e-02 1.490703583623931e-02 1.490117058646935e-02 + 1.489529954725381e-02 1.488942270892006e-02 1.488354007804980e-02 1.487765165385858e-02 1.487175742273507e-02 + 1.486585738883519e-02 1.485995155398175e-02 1.485403990610964e-02 1.484812243988829e-02 1.484219915557141e-02 + 1.483627005584607e-02 1.483033513203473e-02 1.482439437542072e-02 1.481844779264578e-02 1.481249538141862e-02 + 1.480653713381494e-02 1.480057304868135e-02 1.479460312202780e-02 1.478862734716873e-02 1.478264572087699e-02 + 1.477665824308106e-02 1.477066491441443e-02 1.476466572742758e-02 1.475866067903805e-02 1.475264977269339e-02 + 1.474663299844858e-02 1.474061034872640e-02 1.473458182710518e-02 1.472854743115566e-02 1.472250715651883e-02 + 1.471646100132783e-02 1.471040896256117e-02 1.470435103749897e-02 1.469828722554372e-02 1.469221751827344e-02 + 1.468614190646898e-02 1.468006039547928e-02 1.467397298615093e-02 1.466787967378610e-02 1.466178045636883e-02 + 1.465567533041493e-02 1.464956428982840e-02 1.464344732703370e-02 1.463732444018100e-02 1.463119563426315e-02 + 1.462506090797482e-02 1.461892025637629e-02 1.461277367320199e-02 1.460662115516677e-02 1.460046270026797e-02 + 1.459429830605704e-02 1.458812796887011e-02 1.458195168595082e-02 1.457576945823491e-02 1.456958128559711e-02 + 1.456338716422361e-02 1.455718708308891e-02 1.455098103823577e-02 1.454476903226018e-02 1.453855106504101e-02 + 1.453232713525658e-02 1.452609724028033e-02 1.451986137384772e-02 1.451361953112174e-02 1.450737171027855e-02 + 1.450111790831084e-02 1.449485812287890e-02 1.448859235383744e-02 1.448232060352556e-02 1.447604287018101e-02 + 1.446975914267516e-02 1.446346941597466e-02 1.445717368938523e-02 1.445087196279080e-02 1.444456423724572e-02 + 1.443825051237331e-02 1.443193078136921e-02 1.442560503975330e-02 1.441927328581930e-02 1.441293551683267e-02 + 1.440659172970616e-02 1.440024192165075e-02 1.439388609177658e-02 1.438752424156573e-02 1.438115637277796e-02 + 1.437478247503487e-02 1.436840254149195e-02 1.436201657648160e-02 1.435562457263202e-02 1.434922652522855e-02 + 1.434282244486077e-02 1.433641232984850e-02 1.432999617114929e-02 1.432357396196595e-02 1.431714570255755e-02 + 1.431071139387867e-02 1.430427102559402e-02 1.429782460021014e-02 1.429137212732056e-02 1.428491359501307e-02 + 1.427844899676062e-02 1.427197833606156e-02 1.426550161130239e-02 1.425901881685885e-02 1.425252994564961e-02 + 1.424603499980085e-02 1.423953398385027e-02 1.423302689906778e-02 1.422651373475527e-02 1.421999448399202e-02 + 1.421346915585374e-02 1.420693774198730e-02 1.420040023237321e-02 1.419385663850131e-02 1.418730696003290e-02 + 1.418075118751426e-02 1.417418931634679e-02 1.416762135086922e-02 1.416104729584521e-02 1.415446713263836e-02 + 1.414788085973522e-02 1.414128849363525e-02 1.413469002361970e-02 1.412808544052846e-02 1.412147474772301e-02 + 1.411485794712882e-02 1.410823503604182e-02 1.410160600672222e-02 1.409497085818714e-02 1.408832959214252e-02 + 1.408168220875668e-02 1.407502870564407e-02 1.406836907961611e-02 1.406170332864153e-02 1.405503144837146e-02 + 1.404835343608425e-02 1.404166929852345e-02 1.403497903248639e-02 1.402828262916828e-02 1.402158009603205e-02 + 1.401487143048169e-02 1.400815661918214e-02 1.400143566703935e-02 1.399470857625501e-02 1.398797534046779e-02 + 1.398123596549795e-02 1.397449045134991e-02 1.396773878380821e-02 1.396098096640959e-02 1.395421700271061e-02 + 1.394744688102961e-02 1.394067060648909e-02 1.393388818692338e-02 1.392709961198955e-02 1.392030488001634e-02 + 1.391350399327543e-02 1.390669694254475e-02 1.389988372719557e-02 1.389306435287330e-02 1.388623881438261e-02 + 1.387940711188756e-02 1.387256925103053e-02 1.386572522405790e-02 1.385887502683316e-02 1.385201866296698e-02 + 1.384515612379329e-02 1.383828740611332e-02 1.383141252098464e-02 1.382453146615934e-02 1.381764423695148e-02 + 1.381075083621117e-02 1.380385125926009e-02 1.379694549932224e-02 1.379003355634722e-02 1.378311543405784e-02 + 1.377619113577579e-02 1.376926065784134e-02 1.376232399626086e-02 1.375538114862362e-02 1.374843211529037e-02 + 1.374147689626999e-02 1.373451549097131e-02 1.372754790081035e-02 1.372057412482435e-02 1.371359415880417e-02 + 1.370660800191563e-02 1.369961565562416e-02 1.369261712158748e-02 1.368561239160383e-02 1.367860146147292e-02 + 1.367158434223160e-02 1.366456103295884e-02 1.365753152816715e-02 1.365049582984413e-02 1.364345393626983e-02 + 1.363640584363454e-02 1.362935155197557e-02 1.362229106201978e-02 1.361522437421294e-02 1.360815148809621e-02 + 1.360107240365773e-02 1.359398712117658e-02 1.358689563898480e-02 1.357979795217255e-02 1.357269405533802e-02 + 1.356558396017600e-02 1.355846767355538e-02 1.355134518540141e-02 1.354421648973967e-02 1.353708158728038e-02 + 1.352994048497773e-02 1.352279317412557e-02 1.351563964921714e-02 1.350847993234027e-02 1.350131401794928e-02 + 1.349414188812881e-02 1.348696355361660e-02 1.347977901858603e-02 1.347258827670450e-02 1.346539132112732e-02 + 1.345818815687027e-02 1.345097879723517e-02 1.344376323611521e-02 1.343654146470481e-02 1.342931348024562e-02 + 1.342207929164266e-02 1.341483890125029e-02 1.340759229714105e-02 1.340033948592649e-02 1.339308047488992e-02 + 1.338581525615185e-02 1.337854383232506e-02 1.337126620737807e-02 1.336398237245951e-02 1.335669232490426e-02 + 1.334939606999042e-02 1.334209361886319e-02 1.333478496691931e-02 1.332747010093965e-02 1.332014902896288e-02 + 1.331282175723704e-02 1.330548828381385e-02 1.329814860211957e-02 1.329080271412866e-02 1.328345063097246e-02 + 1.327609234424045e-02 1.326872784914616e-02 1.326135715657202e-02 1.325398026514318e-02 1.324659716972378e-02 + 1.323920787031880e-02 1.323181236976987e-02 1.322441067219326e-02 1.321700278123619e-02 1.320958869473772e-02 + 1.320216840889533e-02 1.319474192647233e-02 1.318730924299288e-02 1.317987035320805e-02 1.317242527523754e-02 + 1.316497401404441e-02 1.315751655750498e-02 1.315005290457417e-02 1.314258305915991e-02 1.313510702533477e-02 + 1.312762479749873e-02 1.312013637454663e-02 1.311264176674524e-02 1.310514097528989e-02 1.309763399743803e-02 + 1.309012083240218e-02 1.308260148524151e-02 1.307507595779872e-02 1.306754423810231e-02 1.306000633130083e-02 + 1.305246225068735e-02 1.304491199415833e-02 1.303735555888092e-02 1.302979294561730e-02 1.302222416114251e-02 + 1.301464920127586e-02 1.300706805512286e-02 1.299948074007148e-02 1.299188726392925e-02 1.298428761376350e-02 + 1.297668178953030e-02 1.296906979917289e-02 1.296145165196894e-02 1.295382733572278e-02 1.294619684321666e-02 + 1.293856019418804e-02 1.293091739361701e-02 1.292326843600229e-02 1.291561331594024e-02 1.290795203962965e-02 + 1.290028461406370e-02 1.289261102589192e-02 1.288493127982097e-02 1.287724539399148e-02 1.286955336728896e-02 + 1.286185519483855e-02 1.285415087393522e-02 1.284644040779901e-02 1.283872379943217e-02 1.283100105007112e-02 + 1.282327216499671e-02 1.281553714651719e-02 1.280779599126801e-02 1.280004870582322e-02 1.279229529551004e-02 + 1.278453575462785e-02 1.277677008230648e-02 1.276899828322272e-02 1.276122036637128e-02 1.275343633303281e-02 + 1.274564618082443e-02 1.273784991358546e-02 1.273004753391990e-02 1.272223904101719e-02 1.271442442957637e-02 + 1.270660370794978e-02 1.269877689384363e-02 1.269094397773904e-02 1.268310495443295e-02 1.267525983383190e-02 + 1.266740862159357e-02 1.265955131610305e-02 1.265168790986125e-02 1.264381841321034e-02 1.263594283614933e-02 + 1.262806117310012e-02 1.262017342951705e-02 1.261227961209872e-02 1.260437971406514e-02 1.259647373729069e-02 + 1.258856168925583e-02 1.258064357239260e-02 1.257271939240096e-02 1.256478915520078e-02 1.255685285459754e-02 + 1.254891049173029e-02 1.254096207570647e-02 1.253300760376554e-02 1.252504707668881e-02 1.251708050378790e-02 + 1.250910789128773e-02 1.250112924190730e-02 1.249314455497329e-02 1.248515382942968e-02 1.247715706626537e-02 + 1.246915427066142e-02 1.246114545004359e-02 1.245313061093009e-02 1.244510975519442e-02 1.243708288271855e-02 + 1.242904999334644e-02 1.242101108960597e-02 1.241296617602342e-02 1.240491525784085e-02 1.239685833832253e-02 + 1.238879542265411e-02 1.238072651672425e-02 1.237265161832934e-02 1.236457072972670e-02 1.235648385971585e-02 + 1.234839100475330e-02 1.234029216644840e-02 1.233218735967670e-02 1.232407658450629e-02 1.231595983825897e-02 + 1.230783712734204e-02 1.229970846199802e-02 1.229157384500942e-02 1.228343326032102e-02 1.227528672233900e-02 + 1.226713425500730e-02 1.225897584359588e-02 1.225081148758153e-02 1.224264120133804e-02 1.223446498720786e-02 + 1.222628284514866e-02 1.221809477711035e-02 1.220990079161559e-02 1.220170089405064e-02 1.219349508434973e-02 + 1.218528336781141e-02 1.217706575082829e-02 1.216884223701085e-02 1.216061282093886e-02 1.215237750559525e-02 + 1.214413631491834e-02 1.213588924765066e-02 1.212763629639266e-02 1.211937747504947e-02 1.211111278696468e-02 + 1.210284222899338e-02 1.209456580676226e-02 1.208628352659129e-02 1.207799539529086e-02 1.206970142400196e-02 + 1.206140161359375e-02 1.205309595715539e-02 1.204478446558403e-02 1.203646714593309e-02 1.202814399601385e-02 + 1.201981502726849e-02 1.201148024892713e-02 1.200313965960066e-02 1.199479326438714e-02 1.198644106975963e-02 + 1.197808307814890e-02 1.196971928979660e-02 1.196134970757412e-02 1.195297434273665e-02 1.194459320579336e-02 + 1.193620630286995e-02 1.192781363156250e-02 1.191941519457288e-02 1.191101099930699e-02 1.190260104978759e-02 + 1.189418535108248e-02 1.188576391078268e-02 1.187733673904143e-02 1.186890383909906e-02 1.186046520717658e-02 + 1.185202085452967e-02 1.184357078721630e-02 1.183511499765447e-02 1.182665350164435e-02 1.181818631619212e-02 + 1.180971343948878e-02 1.180123487113532e-02 1.179275061618258e-02 1.178426068678883e-02 1.177576508273127e-02 + 1.176726380098327e-02 1.175875685721244e-02 1.175024426443667e-02 1.174172602804813e-02 1.173320214474543e-02 + 1.172467261918110e-02 1.171613746318596e-02 1.170759667473828e-02 1.169905025976067e-02 1.169049823639713e-02 + 1.168194060529573e-02 1.167337736787376e-02 1.166480853596695e-02 1.165623411322526e-02 1.164765410079015e-02 + 1.163906850325271e-02 1.163047732858534e-02 1.162188058835008e-02 1.161327829716097e-02 1.160467045202270e-02 + 1.159605704763531e-02 1.158743810702480e-02 1.157881363156412e-02 1.157018361041755e-02 1.156154807040710e-02 + 1.155290702254676e-02 1.154426045745637e-02 1.153560838867705e-02 1.152695082724772e-02 1.151828777265603e-02 + 1.150961922666123e-02 1.150094519786783e-02 1.149226570234640e-02 1.148358074611148e-02 1.147489033148848e-02 + 1.146619446355201e-02 1.145749315215113e-02 1.144878640491215e-02 1.144007421936342e-02 1.143135660500108e-02 + 1.142263357779597e-02 1.141390514531738e-02 1.140517131031360e-02 1.139643207471360e-02 1.138768744746770e-02 + 1.137893743736065e-02 1.137018205114591e-02 1.136142129485616e-02 1.135265517811921e-02 1.134388371322748e-02 + 1.133510690045416e-02 1.132632474439678e-02 1.131753726104511e-02 1.130874445081251e-02 1.129994631541456e-02 + 1.129114287234474e-02 1.128233413053084e-02 1.127352009524980e-02 1.126470077646612e-02 1.125587617975814e-02 + 1.124704630615814e-02 1.123821115477194e-02 1.122937074388692e-02 1.122052509984340e-02 1.121167421843202e-02 + 1.120281809651728e-02 1.119395674175946e-02 1.118509017235879e-02 1.117621839625571e-02 1.116734140890626e-02 + 1.115845922925729e-02 1.114957187162777e-02 1.114067933143962e-02 1.113178161769016e-02 1.112287874451852e-02 + 1.111397072153178e-02 1.110505754694771e-02 1.109613922373310e-02 1.108721577854856e-02 1.107828721826434e-02 + 1.106935353946150e-02 1.106041475521090e-02 1.105147087839408e-02 1.104252191603393e-02 1.103356786436798e-02 + 1.102460873384026e-02 1.101564454870664e-02 1.100667531791245e-02 1.099770104268406e-02 1.098872172333136e-02 + 1.097973737703280e-02 1.097074801492989e-02 1.096175363206450e-02 1.095275424291130e-02 1.094374986633713e-02 + 1.093474051123777e-02 1.092572618232803e-02 1.091670688531980e-02 1.090768263148204e-02 1.089865342255811e-02 + 1.088961926240844e-02 1.088058018050034e-02 1.087153618780464e-02 1.086248727940419e-02 1.085343346361914e-02 + 1.084437475261139e-02 1.083531115780061e-02 1.082624268419920e-02 1.081716934144050e-02 1.080809114559821e-02 + 1.079900810312026e-02 1.078992022093278e-02 1.078082751184906e-02 1.077172998533364e-02 1.076262764813011e-02 + 1.075352050586474e-02 1.074440857092024e-02 1.073529185762834e-02 1.072617037570664e-02 1.071704413251609e-02 + 1.070791313635956e-02 1.069877740113652e-02 1.068963693244828e-02 1.068049173224424e-02 1.067134181766250e-02 + 1.066218720670161e-02 1.065302791162099e-02 1.064386393117340e-02 1.063469527249458e-02 1.062552195483164e-02 + 1.061634397913101e-02 1.060716135205155e-02 1.059797409807024e-02 1.058878223029125e-02 1.057958575437316e-02 + 1.057038467384018e-02 1.056117900039964e-02 1.055196874533382e-02 1.054275390960051e-02 1.053353451406393e-02 + 1.052431058354873e-02 1.051508211263400e-02 1.050584910821505e-02 1.049661158906674e-02 1.048736956269110e-02 + 1.047812303544552e-02 1.046887201730896e-02 1.045961652742825e-02 1.045035657823219e-02 1.044109217270465e-02 + 1.043182332652317e-02 1.042255005238709e-02 1.041327235213399e-02 1.040399023555266e-02 1.039470371859749e-02 + 1.038541282005145e-02 1.037611754740451e-02 1.036681790639924e-02 1.035751391340543e-02 1.034820558036888e-02 + 1.033889291336949e-02 1.032957591435120e-02 1.032025460242317e-02 1.031092900384275e-02 1.030159911688449e-02 + 1.029226495054825e-02 1.028292652729243e-02 1.027358385071069e-02 1.026423692589549e-02 1.025488576741323e-02 + 1.024553039300053e-02 1.023617081698821e-02 1.022680704740226e-02 1.021743909457171e-02 1.020806697035185e-02 + 1.019869068658227e-02 1.018931025066223e-02 1.017992567348438e-02 1.017053697875713e-02 1.016114417776936e-02 + 1.015174727399650e-02 1.014234627700861e-02 1.013294120450803e-02 1.012353207457940e-02 1.011411888599992e-02 + 1.010470164920459e-02 1.009528038851809e-02 1.008585511657422e-02 1.007642584330934e-02 1.006699257991301e-02 + 1.005755533847607e-02 1.004811412861271e-02 1.003866895746225e-02 1.002921984502842e-02 1.001976681035788e-02 + 1.001030986009602e-02 1.000084900502786e-02 9.991384259025663e-03 9.981915635495017e-03 9.972443141719819e-03 + 9.962966786689603e-03 9.953486595586885e-03 9.944002583039199e-03 9.934514754395770e-03 9.925023122335749e-03 + 9.915527701693664e-03 9.906028505794947e-03 9.896525539473492e-03 9.887018817044350e-03 9.877508364713565e-03 + 9.867994191756903e-03 9.858476305769829e-03 9.848954721540815e-03 9.839429453723526e-03 9.829900512927632e-03 + 9.820367904529967e-03 9.810831649938153e-03 9.801291772225836e-03 9.791748277276684e-03 9.782201174956444e-03 + 9.772650480173910e-03 9.763096209214261e-03 9.753538370443265e-03 9.743976971083063e-03 9.734412038356991e-03 + 9.724843589152831e-03 9.715271627378256e-03 9.705696167153652e-03 9.696117225097080e-03 9.686534815487291e-03 + 9.676948943754414e-03 9.667359623576509e-03 9.657766883492007e-03 9.648170733986708e-03 9.638571181819185e-03 + 9.628968243024477e-03 9.619361933494769e-03 9.609752265452595e-03 9.600139245296816e-03 9.590522893495216e-03 + 9.580903234511828e-03 9.571280275331249e-03 9.561654026946651e-03 9.552024506017841e-03 9.542391727779683e-03 + 9.532755702177183e-03 9.523116437885958e-03 9.513473960404769e-03 9.503828289303256e-03 9.494179431678001e-03 + 9.484527400058637e-03 9.474872210511853e-03 9.465213879778082e-03 9.455552415295903e-03 9.445887829718797e-03 + 9.436220151655284e-03 9.426549394486200e-03 9.416875565725477e-03 9.407198681221749e-03 9.397518758018270e-03 + 9.387835810148322e-03 9.378149843813783e-03 9.368460878589471e-03 9.358768941430739e-03 9.349074041571485e-03 + 9.339376189353358e-03 9.329675400879622e-03 9.319971694171958e-03 9.310265081086165e-03 9.300555568605354e-03 + 9.290843182951191e-03 9.281127946492163e-03 9.271409865969660e-03 9.261688954922952e-03 9.251965230660204e-03 + 9.242238709904914e-03 9.232509401801155e-03 9.222777318787652e-03 9.213042489474691e-03 9.203304930168641e-03 + 9.193564649383718e-03 9.183821661973759e-03 9.174075985705271e-03 9.164327637046287e-03 9.154576623077591e-03 + 9.144822962285418e-03 9.135066683045857e-03 9.125307796249328e-03 9.115546312613307e-03 9.105782249286811e-03 + 9.096015624756502e-03 9.086246452281876e-03 9.076474739187750e-03 9.066700510968253e-03 9.056923792083085e-03 + 9.047144590189744e-03 9.037362919662660e-03 9.027578799121916e-03 9.017792245480461e-03 9.008003268928564e-03 + 8.998211881680073e-03 8.988418113610518e-03 8.978621982540696e-03 8.968823496265647e-03 8.959022672124209e-03 + 8.949219528590024e-03 8.939414081469170e-03 8.929606339864140e-03 8.919796321979990e-03 8.909984056877767e-03 + 8.900169557867096e-03 8.890352835957138e-03 8.880533907981049e-03 8.870712793191068e-03 8.860889506593549e-03 + 8.851064055633283e-03 8.841236465905915e-03 8.831406764712287e-03 8.821574959648875e-03 8.811741064546590e-03 + 8.801905099237244e-03 8.792067082696866e-03 8.782227026145442e-03 8.772384940188230e-03 8.762540855386065e-03 + 8.752694792574688e-03 8.742846759945761e-03 8.732996774006149e-03 8.723144854408183e-03 8.713291019755398e-03 + 8.703435278608567e-03 8.693577647775636e-03 8.683718159456632e-03 8.673856827661263e-03 8.663993662505663e-03 + 8.654128683145933e-03 8.644261909320558e-03 8.634393356690426e-03 8.624523033451901e-03 8.614650964506795e-03 + 8.604777179373340e-03 8.594901686657006e-03 8.585024500118565e-03 8.575145640490715e-03 8.565265126670765e-03 + 8.555382971806235e-03 8.545499187654319e-03 8.535613803632294e-03 8.525726842250045e-03 8.515838312646278e-03 + 8.505948232174527e-03 8.496056621077198e-03 8.486163497882877e-03 8.476268872748003e-03 8.466372762116349e-03 + 8.456475199094931e-03 8.446576199856061e-03 8.436675774300739e-03 8.426773941795081e-03 8.416870722731803e-03 + 8.406966134358667e-03 8.397060186389057e-03 8.387152901959176e-03 8.377244311160385e-03 8.367334425300299e-03 + 8.357423258296441e-03 8.347510830980188e-03 8.337597163605794e-03 8.327682270401855e-03 8.317766161869340e-03 + 8.307848867754637e-03 8.297930413816063e-03 8.288010810083676e-03 8.278090072673102e-03 8.268168221765407e-03 + 8.258245278027963e-03 8.248321253600945e-03 8.238396163758082e-03 8.228470040664376e-03 8.218542903042886e-03 + 8.208614761992156e-03 8.198685637447353e-03 8.188755549837494e-03 8.178824516773604e-03 8.168892549578916e-03 + 8.158959670459199e-03 8.149025910256038e-03 8.139091282816925e-03 8.129155801857130e-03 8.119219487437710e-03 + 8.109282361690508e-03 8.099344440765549e-03 8.089405733754036e-03 8.079466270417937e-03 8.069526079135253e-03 + 8.059585169010465e-03 8.049643556954327e-03 8.039701265060109e-03 8.029758314127560e-03 8.019814717074126e-03 + 8.009870488264625e-03 7.999925660293698e-03 7.989980254561855e-03 7.980034282561204e-03 7.970087763203990e-03 + 7.960140717914167e-03 7.950193166721423e-03 7.940245120231920e-03 7.930296599391260e-03 7.920347637831796e-03 + 7.910398250263278e-03 7.900448449763646e-03 7.890498257622273e-03 7.880547695356892e-03 7.870596780430528e-03 + 7.860645524802819e-03 7.850693955430419e-03 7.840742100859013e-03 7.830789973961963e-03 7.820837591210042e-03 + 7.810884973654219e-03 7.800932143705464e-03 7.790979115476222e-03 7.781025902060369e-03 7.771072537550891e-03 + 7.761119045304192e-03 7.751165435253132e-03 7.741211727248220e-03 7.731257943744334e-03 7.721304105116559e-03 + 7.711350222852130e-03 7.701396316987202e-03 7.691442422531397e-03 7.681488555826352e-03 7.671534729460651e-03 + 7.661580965493510e-03 7.651627286213397e-03 7.641673709645761e-03 7.631720246474624e-03 7.621766924002147e-03 + 7.611813774300424e-03 7.601860809420407e-03 7.591908045212342e-03 7.581955503946372e-03 7.572003208680656e-03 + 7.562051174726026e-03 7.552099414296815e-03 7.542147961065804e-03 7.532196840825635e-03 7.522246063843738e-03 + 7.512295650102864e-03 7.502345622322073e-03 7.492396000716249e-03 7.482446799189802e-03 7.472498037196947e-03 + 7.462549747897286e-03 7.452601950331629e-03 7.442654658211039e-03 7.432707892744488e-03 7.422761676416634e-03 + 7.412816028768508e-03 7.402870961455420e-03 7.392926500328647e-03 7.382982678429822e-03 7.373039508794957e-03 + 7.363097007225734e-03 7.353155196864952e-03 7.343214100532815e-03 7.333273734782904e-03 7.323334112197604e-03 + 7.313395265021593e-03 7.303457220900774e-03 7.293519991033275e-03 7.283583594600794e-03 7.273648054943689e-03 + 7.263713394446934e-03 7.253779626580373e-03 7.243846768480717e-03 7.233914855435080e-03 7.223983908518886e-03 + 7.214053940460562e-03 7.204124972417771e-03 7.194197027491048e-03 7.184270126394881e-03 7.174344280726286e-03 + 7.164419514784642e-03 7.154495863236941e-03 7.144573340914020e-03 7.134651962993328e-03 7.124731752265264e-03 + 7.114812732100897e-03 7.104894920638768e-03 7.094978330575343e-03 7.085062992246606e-03 7.075148934793896e-03 + 7.065236171017366e-03 7.055324719420953e-03 7.045414603125002e-03 7.035505845669364e-03 7.025598461448587e-03 + 7.015692466009597e-03 7.005787894887785e-03 6.995884771371198e-03 6.985983107977662e-03 6.976082925249031e-03 + 6.966184246523457e-03 6.956287093797063e-03 6.946391479271966e-03 6.936497425652844e-03 6.926604968509339e-03 + 6.916714124366364e-03 6.906824907731460e-03 6.896937340931554e-03 6.887051448149962e-03 6.877167248699087e-03 + 6.867284753979424e-03 6.857403994050719e-03 6.847525000658012e-03 6.837647785670592e-03 6.827772367409923e-03 + 6.817898770109592e-03 6.808027016717447e-03 6.798157122708669e-03 6.788289103240300e-03 6.778422992931511e-03 + 6.768558816798320e-03 6.758696587557012e-03 6.748836325648165e-03 6.738978054348659e-03 6.729121795949092e-03 + 6.719267563927435e-03 6.709415379633438e-03 6.699565278400954e-03 6.689717278120727e-03 6.679871393303892e-03 + 6.670027647355804e-03 6.660186063525513e-03 6.650346660981845e-03 6.640509452367944e-03 6.630674466396449e-03 + 6.620841735868644e-03 6.611011273308148e-03 6.601183096392477e-03 6.591357229649247e-03 6.581533696087914e-03 + 6.571712512145987e-03 6.561893692372858e-03 6.552077270290561e-03 6.542263272668194e-03 6.532451712617284e-03 + 6.522642609933696e-03 6.512835987879551e-03 6.503031869590782e-03 6.493230268870023e-03 6.483431205156500e-03 + 6.473634714105858e-03 6.463840816056773e-03 6.454049525191551e-03 6.444260863046832e-03 6.434474853362258e-03 + 6.424691517208967e-03 6.414910866799055e-03 6.405132928351729e-03 6.395357735592168e-03 6.385585303753894e-03 + 6.375815649717760e-03 6.366048796411005e-03 6.356284767471845e-03 6.346523580477974e-03 6.336765248927921e-03 + 6.327009805730009e-03 6.317257279178600e-03 6.307507681412946e-03 6.297761032647583e-03 6.288017356862164e-03 + 6.278276676438099e-03 6.268539005625230e-03 6.258804362658888e-03 6.249072783406197e-03 6.239344289504087e-03 + 6.229618894349891e-03 6.219896619699197e-03 6.210177489065160e-03 6.200461523673893e-03 6.190748736475173e-03 + 6.181039151999554e-03 6.171332804226705e-03 6.161629709556120e-03 6.151929884103313e-03 6.142233350147177e-03 + 6.132540131644584e-03 6.122850247356021e-03 6.113163710170625e-03 6.103480551213418e-03 6.093800800141988e-03 + 6.084124469547710e-03 6.074451578566364e-03 6.064782150905211e-03 6.055116209626953e-03 6.045453769994722e-03 + 6.035794848740185e-03 6.026139480474754e-03 6.016487688229946e-03 6.006839485237500e-03 5.997194892776407e-03 + 5.987553934341584e-03 5.977916631713333e-03 5.968282997802390e-03 5.958653055343909e-03 5.949026838944569e-03 + 5.939404365780911e-03 5.929785651209331e-03 5.920170717549854e-03 5.910559587858684e-03 5.900952281370824e-03 + 5.891348811852907e-03 5.881749208142844e-03 5.872153500225121e-03 5.862561701850070e-03 5.852973831530551e-03 + 5.843389912374926e-03 5.833809966833203e-03 5.824234011006907e-03 5.814662060999971e-03 5.805094150375409e-03 + 5.795530303292347e-03 5.785970532524381e-03 5.776414859211175e-03 5.766863306294991e-03 5.757315894674337e-03 + 5.747772638659374e-03 5.738233559732430e-03 5.728698691311226e-03 5.719168051719483e-03 5.709641656042984e-03 + 5.700119526414031e-03 5.690601685377130e-03 5.681088152168133e-03 5.671578940158426e-03 5.662074076665564e-03 + 5.652573592801510e-03 5.643077502877857e-03 5.633585823810169e-03 5.624098577633230e-03 5.614615788052954e-03 + 5.605137471831965e-03 5.595663642810052e-03 5.586194333773162e-03 5.576729570469775e-03 5.567269364923084e-03 + 5.557813736696195e-03 5.548362708847973e-03 5.538916303890826e-03 5.529474534822445e-03 5.520037420561356e-03 + 5.510604996543656e-03 5.501177281279281e-03 5.491754287530179e-03 5.482336037985177e-03 5.472922555453679e-03 + 5.463513859119052e-03 5.454109961206277e-03 5.444710887376439e-03 5.435316669896643e-03 5.425927322428118e-03 + 5.416542861379438e-03 5.407163309793553e-03 5.397788689388935e-03 5.388419016905312e-03 5.379054306533677e-03 + 5.369694588817857e-03 5.360339890208465e-03 5.350990223294556e-03 5.341645606645782e-03 5.332306062415535e-03 + 5.322971612709802e-03 5.313642271564683e-03 5.304318056285795e-03 5.294999000250198e-03 5.285685123732157e-03 + 5.276376439554206e-03 5.267072968338082e-03 5.257774732353860e-03 5.248481751732874e-03 5.239194038865901e-03 + 5.229911616755654e-03 5.220634516968343e-03 5.211362754853240e-03 5.202096346092698e-03 5.192835312362628e-03 + 5.183579674966123e-03 5.174329450821569e-03 5.165084652994387e-03 5.155845310548846e-03 5.146611450951191e-03 + 5.137383086378589e-03 5.128160234647254e-03 5.118942917508807e-03 5.109731156137037e-03 5.100524965000140e-03 + 5.091324360054826e-03 5.082129373049942e-03 5.072940025255639e-03 5.063756329149303e-03 5.054578304260502e-03 + 5.045405972366202e-03 5.036239353680495e-03 5.027078459118392e-03 5.017923310123222e-03 5.008773940483098e-03 + 4.999630364315774e-03 4.990492594829337e-03 4.981360654331298e-03 4.972234563790402e-03 4.963114339923834e-03 + 4.953999995020500e-03 4.944891556281875e-03 4.935789051765770e-03 4.926692493194353e-03 4.917601897109304e-03 + 4.908517284729773e-03 4.899438676825864e-03 4.890366088012707e-03 4.881299532722441e-03 4.872239041569468e-03 + 4.863184636415129e-03 4.854136328649667e-03 4.845094137498133e-03 4.836058083872883e-03 4.827028186746977e-03 + 4.818004458681770e-03 4.808986918914880e-03 4.799975597861264e-03 4.790970512088721e-03 4.781971675128856e-03 + 4.772979106768043e-03 4.763992827229902e-03 4.755012853632298e-03 4.746039197549013e-03 4.737071883993436e-03 + 4.728110941197518e-03 4.719156380399636e-03 4.710208217424537e-03 4.701266473663848e-03 4.692331168251817e-03 + 4.683402315353613e-03 4.674479928383867e-03 4.665564036556664e-03 4.656654662394768e-03 4.647751816371710e-03 + 4.638855516650367e-03 4.629965783672686e-03 4.621082635909843e-03 4.612206084994354e-03 4.603336148102954e-03 + 4.594472856159325e-03 4.585616225744373e-03 4.576766268345947e-03 4.567923003199363e-03 4.559086450091263e-03 + 4.550256626033265e-03 4.541433541986122e-03 4.532617220194613e-03 4.523807688535670e-03 4.515004959722835e-03 + 4.506209047920159e-03 4.497419972185719e-03 4.488637751873642e-03 4.479862401381760e-03 4.471093932025212e-03 + 4.462332371280023e-03 4.453577742726973e-03 4.444830056583276e-03 4.436089328917552e-03 4.427355578888171e-03 + 4.418628824988929e-03 4.409909078668640e-03 4.401196354933857e-03 4.392490684030716e-03 4.383792083151365e-03 + 4.375100562120779e-03 4.366416138313078e-03 4.357738831525952e-03 4.349068659591380e-03 4.340405630957790e-03 + 4.331749765364269e-03 4.323101091949651e-03 4.314459623208851e-03 4.305825371349630e-03 4.297198354190413e-03 + 4.288578590720092e-03 4.279966095343473e-03 4.271360877578565e-03 4.262762963097229e-03 4.254172376200769e-03 + 4.245589126222103e-03 4.237013227440267e-03 4.228444697962537e-03 4.219883556022182e-03 4.211329813254019e-03 + 4.202783482548908e-03 4.194244591796649e-03 4.185713159116739e-03 4.177189194188086e-03 4.168672712320958e-03 + 4.160163731860882e-03 4.151662270610665e-03 4.143168336754119e-03 4.134681947397693e-03 4.126203130809124e-03 + 4.117731899759874e-03 4.109268265260960e-03 4.100812244167818e-03 4.092363854125291e-03 4.083923109325604e-03 + 4.075490018959178e-03 4.067064605609816e-03 4.058646892914489e-03 4.050236890474988e-03 4.041834611549669e-03 + 4.033440073099425e-03 4.025053291802670e-03 4.016674279190388e-03 4.008303046950822e-03 3.999939621219669e-03 + 3.991584019864232e-03 3.983236251035503e-03 3.974896329846703e-03 3.966564273682151e-03 3.958240098637734e-03 + 3.949923812376889e-03 3.941615430268695e-03 3.933314980874398e-03 3.925022475755094e-03 3.916737923312982e-03 + 3.908461340476090e-03 3.900192744628528e-03 3.891932149238224e-03 3.883679560814138e-03 3.875435000263637e-03 + 3.867198492508630e-03 3.858970045729460e-03 3.850749670926077e-03 3.842537384120139e-03 3.834333202377867e-03 + 3.826137136626801e-03 3.817949195349815e-03 3.809769403427763e-03 3.801597779587331e-03 3.793434330750140e-03 + 3.785279069923421e-03 3.777132013373491e-03 3.768993177352847e-03 3.760862568898475e-03 3.752740200334732e-03 + 3.744626099044159e-03 3.736520277340854e-03 3.728422742215669e-03 3.720333508785603e-03 3.712252593018920e-03 + 3.704180008090329e-03 3.696115760631814e-03 3.688059868276574e-03 3.680012354362612e-03 3.671973228138760e-03 + 3.663942499526064e-03 3.655920182566113e-03 3.647906292785413e-03 3.639900840938008e-03 3.631903834337251e-03 + 3.623915295229000e-03 3.615935242250758e-03 3.607963681828620e-03 3.600000626081414e-03 3.592046089865790e-03 + 3.584100087061132e-03 3.576162625323692e-03 3.568233715505030e-03 3.560313381862740e-03 3.552401637255495e-03 + 3.544498488187401e-03 3.536603947761108e-03 3.528718030587010e-03 3.520840749407267e-03 3.512972109975055e-03 + 3.505112127471606e-03 3.497260824593953e-03 3.489418209893856e-03 3.481584291815555e-03 3.473759083632174e-03 + 3.465942599385497e-03 3.458134849136788e-03 3.450335838875430e-03 3.442545588595099e-03 3.434764116831954e-03 + 3.426991428902786e-03 3.419227535146918e-03 3.411472449427477e-03 3.403726185233638e-03 3.395988749408295e-03 + 3.388260149964055e-03 3.380540409506120e-03 3.372829541439428e-03 3.365127551327278e-03 3.357434450344299e-03 + 3.349750251864305e-03 3.342074968176267e-03 3.334408603200120e-03 3.326751169911567e-03 3.319102691777129e-03 + 3.311463175183513e-03 3.303832626198486e-03 3.296211059114474e-03 3.288598486024217e-03 3.280994915398627e-03 + 3.273400352769854e-03 3.265814815709593e-03 3.258238322074859e-03 3.250670876135365e-03 3.243112486983179e-03 + 3.235563167624456e-03 3.228022929479646e-03 3.220491779361285e-03 3.212969724272006e-03 3.205456783570964e-03 + 3.197952970426890e-03 3.190458290104943e-03 3.182972751519780e-03 3.175496366385864e-03 3.168029146873250e-03 + 3.160571096621216e-03 3.153122225636278e-03 3.145682555500280e-03 3.138252093348739e-03 3.130830843615626e-03 + 3.123418817816768e-03 3.116016027518625e-03 3.108622481356378e-03 3.101238183229207e-03 3.093863147897005e-03 + 3.086497392737253e-03 3.079140921752824e-03 3.071793741871484e-03 3.064455864252268e-03 3.057127299904285e-03 + 3.049808055146270e-03 3.042498134791386e-03 3.035197556645182e-03 3.027906333235584e-03 3.020624467536793e-03 + 3.013351968343262e-03 3.006088846580162e-03 2.998835112089031e-03 2.991590768047797e-03 2.984355822285627e-03 + 2.977130294631421e-03 2.969914192263928e-03 2.962707518230782e-03 2.955510282832787e-03 2.948322496039390e-03 + 2.941144165204636e-03 2.933975293458325e-03 2.926815893073326e-03 2.919665980487675e-03 2.912525559332239e-03 + 2.905394635071103e-03 2.898273217656210e-03 2.891161316595433e-03 2.884058936906487e-03 2.876966081111658e-03 + 2.869882766189157e-03 2.862809005041444e-03 2.855744798230348e-03 2.848690153100023e-03 2.841645079496137e-03 + 2.834609585256340e-03 2.827583673848185e-03 2.820567351490293e-03 2.813560634590312e-03 2.806563530531927e-03 + 2.799576041999259e-03 2.792598177467573e-03 2.785629945309582e-03 2.778671351607254e-03 2.771722398039775e-03 + 2.764783095014263e-03 2.757853459091809e-03 2.750933492568204e-03 2.744023198517816e-03 2.737122585640385e-03 + 2.730231662189404e-03 2.723350432970404e-03 2.716478899800820e-03 2.709617075896625e-03 2.702764973241287e-03 + 2.695922593060963e-03 2.689089940152226e-03 2.682267022316270e-03 2.675453847914084e-03 2.668650418902243e-03 + 2.661856738145520e-03 2.655072822033232e-03 2.648298678030288e-03 2.641534306206961e-03 2.634779712258937e-03 + 2.628034904058933e-03 2.621299888635041e-03 2.614574665771587e-03 2.607859242632423e-03 2.601153634957146e-03 + 2.594457844452072e-03 2.587771872555374e-03 2.581095727373358e-03 2.574429415266960e-03 2.567772939497474e-03 + 2.561126300777387e-03 2.554489510835181e-03 2.547862581281132e-03 2.541245510713479e-03 2.534638303078699e-03 + 2.528040966193904e-03 2.521453505493298e-03 2.514875922225054e-03 2.508308218200437e-03 2.501750407164573e-03 + 2.495202496081871e-03 2.488664484118587e-03 2.482136376281468e-03 2.475618178705269e-03 2.469109895957427e-03 + 2.462611527825166e-03 2.456123079328407e-03 2.449644563898542e-03 2.443175984269443e-03 2.436717340526153e-03 + 2.430268636964234e-03 2.423829879853036e-03 2.417401073311931e-03 2.410982215756923e-03 2.404573315098301e-03 + 2.398174382071132e-03 2.391785416912405e-03 2.385406421217447e-03 2.379037399546287e-03 2.372678357701878e-03 + 2.366329296305038e-03 2.359990214012962e-03 2.353661123666590e-03 2.347342032379030e-03 2.341032936953993e-03 + 2.334733840455562e-03 2.328444748068140e-03 2.322165663885325e-03 2.315896586946297e-03 2.309637519733881e-03 + 2.303388473653537e-03 2.297149451184649e-03 2.290920451297887e-03 2.284701476927273e-03 2.278492533074980e-03 + 2.272293622898508e-03 2.266104742447669e-03 2.259925897918875e-03 2.253757100645447e-03 2.247598348619136e-03 + 2.241449641489242e-03 2.235310983406359e-03 2.229182378556762e-03 2.223063827011661e-03 2.216955326220785e-03 + 2.210856885615230e-03 2.204768511855369e-03 2.198690202073136e-03 2.192621957162963e-03 2.186563780523993e-03 + 2.180515675851768e-03 2.174477640514074e-03 2.168449674335647e-03 2.162431789038673e-03 2.156423986093689e-03 + 2.150426261719325e-03 2.144438618887063e-03 2.138461061015507e-03 2.132493589319895e-03 2.126536199820428e-03 + 2.120588896234097e-03 2.114651688169617e-03 2.108724573757348e-03 2.102807551461262e-03 2.096900623831682e-03 + 2.091003792760502e-03 2.085117057433877e-03 2.079240415028002e-03 2.073373872799373e-03 2.067517436442142e-03 + 2.061671101563673e-03 2.055834867994772e-03 2.050008738194652e-03 2.044192713868095e-03 2.038386792128391e-03 + 2.032590971333173e-03 2.026805260662020e-03 2.021029661329869e-03 2.015264168518725e-03 2.009508783500123e-03 + 2.003763508166370e-03 1.998028342654997e-03 1.992303282805534e-03 1.986588330078225e-03 1.980883492165770e-03 + 1.975188767039759e-03 1.969504151730439e-03 1.963829647004430e-03 1.958165254218237e-03 1.952510971963634e-03 + 1.946866794889960e-03 1.941232728159857e-03 1.935608777640074e-03 1.929994938329363e-03 1.924391207914093e-03 + 1.918797587114099e-03 1.913214077256622e-03 1.907640674795718e-03 1.902077375557082e-03 1.896524186430478e-03 + 1.890981108949087e-03 1.885448138032121e-03 1.879925272541809e-03 1.874412513138102e-03 1.868909859971047e-03 + 1.863417306389931e-03 1.857934851379391e-03 1.852462503653811e-03 1.847000259754348e-03 1.841548114039762e-03 + 1.836106066817225e-03 1.830674118529854e-03 1.825252266916765e-03 1.819840505202892e-03 1.814438836319749e-03 + 1.809047265638602e-03 1.803665787133681e-03 1.798294397101445e-03 1.792933095135866e-03 1.787581880369786e-03 + 1.782240749155103e-03 1.776909697172910e-03 1.771588728179710e-03 1.766277842767543e-03 1.760977035675204e-03 + 1.755686304337379e-03 1.750405647484752e-03 1.745135063548007e-03 1.739874546386865e-03 1.734624093589025e-03 + 1.729383711586370e-03 1.724153396315838e-03 1.718933140719367e-03 1.713722944309894e-03 1.708522806163372e-03 + 1.703332722978997e-03 1.698152687791741e-03 1.692982700783420e-03 1.687822765464940e-03 1.682672875794938e-03 + 1.677533027054054e-03 1.672403217813849e-03 1.667283446525115e-03 1.662173708173832e-03 1.657073995739192e-03 + 1.651984312946546e-03 1.646904660364047e-03 1.641835029387390e-03 1.636775416468660e-03 1.631725820220986e-03 + 1.626686238226539e-03 1.621656663682810e-03 1.616637091835148e-03 1.611627526662728e-03 1.606627964700548e-03 + 1.601638398623349e-03 1.596658825754688e-03 1.591689243408400e-03 1.586729647378206e-03 1.581780030725023e-03 + 1.576840391697073e-03 1.571910732264727e-03 1.566991046477593e-03 1.562081328242421e-03 1.557181574037859e-03 + 1.552291781114454e-03 1.547411944138861e-03 1.542542055154552e-03 1.537682115822498e-03 1.532832126356767e-03 + 1.527992077470792e-03 1.523161963747274e-03 1.518341782422417e-03 1.513531530571088e-03 1.508731200913292e-03 + 1.503940786876937e-03 1.499160290964809e-03 1.494389709200610e-03 1.489629032745148e-03 1.484878257820629e-03 + 1.480137381279299e-03 1.475406398389162e-03 1.470685299850305e-03 1.465974082141071e-03 1.461272748080975e-03 + 1.456581290224651e-03 1.451899700275850e-03 1.447227974089072e-03 1.442566108566721e-03 1.437914097994959e-03 + 1.433271932504185e-03 1.428639611034298e-03 1.424017133356480e-03 1.419404490680891e-03 1.414801676491448e-03 + 1.410208686553135e-03 1.405625516589791e-03 1.401052158609908e-03 1.396488604511052e-03 1.391934855472548e-03 + 1.387390907364871e-03 1.382856750165021e-03 1.378332378783991e-03 1.373817788890047e-03 1.369312974750468e-03 + 1.364817927255285e-03 1.360332641059443e-03 1.355857116711623e-03 1.351391347026849e-03 1.346935323100728e-03 + 1.342489039284644e-03 1.338052491255308e-03 1.333625672740901e-03 1.329208572800934e-03 1.324801188462658e-03 + 1.320403519143769e-03 1.316015555822497e-03 1.311637290544184e-03 1.307268717472159e-03 1.302909831116118e-03 + 1.298560623326278e-03 1.294221085253892e-03 1.289891216124110e-03 1.285571011566486e-03 1.281260461060531e-03 + 1.276959557618139e-03 1.272668295740209e-03 1.268386669608614e-03 1.264114669618853e-03 1.259852288349743e-03 + 1.255599524419093e-03 1.251356371085625e-03 1.247122819189722e-03 1.242898861265979e-03 1.238684491359706e-03 + 1.234479702756933e-03 1.230284484841117e-03 1.226098832748256e-03 1.221922744434409e-03 1.217756210326720e-03 + 1.213599221362577e-03 1.209451770765583e-03 1.205313852635065e-03 1.201185458480448e-03 1.197066577985755e-03 + 1.192957208640432e-03 1.188857345511447e-03 1.184766976969275e-03 1.180686095693037e-03 1.176614695732404e-03 + 1.172552769621902e-03 1.168500307042727e-03 1.164457299537124e-03 1.160423745213695e-03 1.156399636114517e-03 + 1.152384961360659e-03 1.148379714206853e-03 1.144383887440774e-03 1.140397472403066e-03 1.136420458871837e-03 + 1.132452840804467e-03 1.128494614815977e-03 1.124545770440235e-03 1.120606297984056e-03 1.116676190709075e-03 + 1.112755440623707e-03 1.108844038267568e-03 1.104941973598277e-03 1.101049242215234e-03 1.097165838523137e-03 + 1.093291750933755e-03 1.089426970747485e-03 1.085571490835547e-03 1.081725303225761e-03 1.077888396808512e-03 + 1.074060761522748e-03 1.070242395009795e-03 1.066433289590875e-03 1.062633433332422e-03 1.058842817553080e-03 + 1.055061434373011e-03 1.051289275348505e-03 1.047526329409495e-03 1.043772588486000e-03 1.040028047931513e-03 + 1.036292698203525e-03 1.032566529042292e-03 1.028849531681517e-03 1.025141697676040e-03 1.021443017315572e-03 + 1.017753479165712e-03 1.014073077446178e-03 1.010401806565697e-03 1.006739654876394e-03 1.003086612170896e-03 + 9.994426698862881e-04 9.958078198244436e-04 9.921820510029489e-04 9.885653522799815e-04 9.849577193159157e-04 + 9.813591440739670e-04 9.777696142556011e-04 9.741891204675346e-04 9.706176542328248e-04 9.670552065524777e-04 + 9.635017651512704e-04 9.599573207794398e-04 9.564218691437683e-04 9.528953995809905e-04 9.493779002331982e-04 + 9.458693621672339e-04 9.423697766254766e-04 9.388791334439822e-04 9.353974200435674e-04 9.319246293443443e-04 + 9.284607555133966e-04 9.250057861419034e-04 9.215597102726345e-04 9.181225189615299e-04 9.146942031524666e-04 + 9.112747514066988e-04 9.078641516289516e-04 9.044623983719834e-04 9.010694834242857e-04 8.976853937790154e-04 + 8.943101192935385e-04 8.909436508104612e-04 8.875859786393426e-04 8.842370902316334e-04 8.808969751654204e-04 + 8.775656281905130e-04 8.742430385918343e-04 8.709291937982416e-04 8.676240840155020e-04 8.643276998573467e-04 + 8.610400308208924e-04 8.577610636611962e-04 8.544907899714905e-04 8.512292035626933e-04 8.479762917886125e-04 + 8.447320428739457e-04 8.414964471843920e-04 8.382694949325988e-04 8.350511744137459e-04 8.318414728923707e-04 + 8.286403836395943e-04 8.254478982373706e-04 8.222640032931049e-04 8.190886878204532e-04 8.159219419987107e-04 + 8.127637556794064e-04 8.096141160179775e-04 8.064730115089579e-04 8.033404360997527e-04 8.002163789609624e-04 + 7.971008268111541e-04 7.939937692507287e-04 7.908951962853333e-04 7.878050969946667e-04 7.847234577702081e-04 + 7.816502689905088e-04 7.785855239466778e-04 7.755292098590464e-04 7.724813142232633e-04 7.694418267842021e-04 + 7.664107372089749e-04 7.633880335334087e-04 7.603737023812342e-04 7.573677358642847e-04 7.543701253849379e-04 + 7.513808572285544e-04 7.483999196962093e-04 7.454273024026923e-04 7.424629947358947e-04 7.395069836664074e-04 + 7.365592567622367e-04 7.336198070174806e-04 7.306886236388442e-04 7.277656929130117e-04 7.248510036837761e-04 + 7.219445453636994e-04 7.190463067357669e-04 7.161562739946586e-04 7.132744364309508e-04 7.104007867132190e-04 + 7.075353120392018e-04 7.046779992824802e-04 7.018288375861283e-04 6.989878161882759e-04 6.961549229362052e-04 + 6.933301438820412e-04 6.905134700383686e-04 6.877048926511914e-04 6.849043978549774e-04 6.821119732944710e-04 + 6.793276080246700e-04 6.765512910034699e-04 6.737830090783149e-04 6.710227490756584e-04 6.682705030776122e-04 + 6.655262603091742e-04 6.627900067379164e-04 6.600617305924390e-04 6.573414207627890e-04 6.546290656955580e-04 + 6.519246513982958e-04 6.492281662548372e-04 6.465396024423735e-04 6.438589471596415e-04 6.411861867028291e-04 + 6.385213096762252e-04 6.358643049114898e-04 6.332151601148890e-04 6.305738609661260e-04 6.279403974635571e-04 + 6.253147606410383e-04 6.226969365620930e-04 6.200869123319087e-04 6.174846765257772e-04 6.148902176504979e-04 + 6.123035224628875e-04 6.097245772740803e-04 6.071533733723410e-04 6.045898999580564e-04 6.020341426510520e-04 + 5.994860891934145e-04 5.969457280748620e-04 5.944130474177512e-04 5.918880332091087e-04 5.893706730594447e-04 + 5.868609584534629e-04 5.843588766665737e-04 5.818644136544619e-04 5.793775576682911e-04 5.768982970317317e-04 + 5.744266191686133e-04 5.719625097277512e-04 5.695059578510202e-04 5.670569542308351e-04 5.646154849082753e-04 + 5.621815365284883e-04 5.597550972743215e-04 5.573361553519681e-04 5.549246974872960e-04 5.525207095632259e-04 + 5.501241820142805e-04 5.477351040267441e-04 5.453534610951853e-04 5.429792405131840e-04 5.406124304314462e-04 + 5.382530187447214e-04 5.359009913605971e-04 5.335563351904396e-04 5.312190411682156e-04 5.288890968140364e-04 + 5.265664878332606e-04 5.242512018091515e-04 5.219432267978740e-04 5.196425502978362e-04 5.173491576918976e-04 + 5.150630373381158e-04 5.127841797796618e-04 5.105125710953982e-04 5.082481974966798e-04 5.059910467933278e-04 + 5.037411069671739e-04 5.014983647643853e-04 4.992628057533249e-04 4.970344196034297e-04 4.948131954905409e-04 + 4.925991188614672e-04 4.903921766298550e-04 4.881923566574878e-04 4.859996466359864e-04 4.838140324815327e-04 + 4.816355005995136e-04 4.794640414647377e-04 4.772996426854546e-04 4.751422896755638e-04 4.729919697488023e-04 + 4.708486707166207e-04 4.687123799720691e-04 4.665830828962369e-04 4.644607671738101e-04 4.623454230212830e-04 + 4.602370366779194e-04 4.581355941018685e-04 4.560410828358216e-04 4.539534906171381e-04 4.518728041821612e-04 + 4.497990089033435e-04 4.477320938149108e-04 4.456720481170030e-04 4.436188572707195e-04 4.415725078895158e-04 + 4.395329875976124e-04 4.375002838422590e-04 4.354743826722610e-04 4.334552702201095e-04 4.314429363226086e-04 + 4.294373687059989e-04 4.274385527576286e-04 4.254464755700176e-04 4.234611247199864e-04 4.214824874479911e-04 + 4.195105492176435e-04 4.175452972239935e-04 4.155867214135851e-04 4.136348082067204e-04 4.116895433467350e-04 + 4.097509141339746e-04 4.078189081189173e-04 4.058935120995524e-04 4.039747114386321e-04 4.020624945699733e-04 + 4.001568506324645e-04 3.982577652062802e-04 3.963652246433777e-04 3.944792163840573e-04 3.925997278951708e-04 + 3.907267452820787e-04 3.888602542761684e-04 3.870002443827855e-04 3.851467035420477e-04 3.832996170232135e-04 + 3.814589716941001e-04 3.796247550166885e-04 3.777969542187427e-04 3.759755548771444e-04 3.741605437648361e-04 + 3.723519105456335e-04 3.705496418343326e-04 3.687537232626712e-04 3.669641420580878e-04 3.651808856652343e-04 + 3.634039408935104e-04 3.616332930379869e-04 3.598689301103073e-04 3.581108413327368e-04 3.563590123412032e-04 + 3.546134293224166e-04 3.528740796868620e-04 3.511409507353364e-04 3.494140287293094e-04 3.476932993968030e-04 + 3.459787517007610e-04 3.442703736842207e-04 3.425681507579447e-04 3.408720696736798e-04 3.391821178070990e-04 + 3.374982823340253e-04 3.358205489790399e-04 3.341489042294683e-04 3.324833375391577e-04 3.308238358267097e-04 + 3.291703846864138e-04 3.275229711235071e-04 3.258815824857735e-04 3.242462057388915e-04 3.226168264116891e-04 + 3.209934320343741e-04 3.193760116170641e-04 3.177645512713499e-04 3.161590371207419e-04 3.145594562690266e-04 + 3.129657961319975e-04 3.113780432227079e-04 3.097961831114660e-04 3.082202043645004e-04 3.066500952444524e-04 + 3.050858414009347e-04 3.035274294402161e-04 3.019748466354355e-04 3.004280802320956e-04 2.988871162192853e-04 + 2.973519409077311e-04 2.958225434173786e-04 2.942989109163873e-04 2.927810290941792e-04 2.912688849504159e-04 + 2.897624658129895e-04 2.882617587216531e-04 2.867667493909568e-04 2.852774250910157e-04 2.837937747837379e-04 + 2.823157848000407e-04 2.808434412718301e-04 2.793767313619733e-04 2.779156424588856e-04 2.764601612241833e-04 + 2.750102732798498e-04 2.735659669757869e-04 2.721272307826111e-04 2.706940504177620e-04 2.692664125118005e-04 + 2.678443044384447e-04 2.664277133531666e-04 2.650166254907073e-04 2.636110271946842e-04 2.622109073508727e-04 + 2.608162534146021e-04 2.594270512444905e-04 2.580432877716125e-04 2.566649503351083e-04 2.552920261463284e-04 + 2.539245011192165e-04 2.525623623480746e-04 2.512055988243127e-04 2.498541971146173e-04 2.485081433825346e-04 + 2.471674249383843e-04 2.458320291468696e-04 2.445019428356345e-04 2.431771519464020e-04 2.418576445147758e-04 + 2.405434090455539e-04 2.392344316436903e-04 2.379306989304936e-04 2.366321982706708e-04 2.353389171046539e-04 + 2.340508418959193e-04 2.327679588365217e-04 2.314902568213100e-04 2.302177235947735e-04 2.289503450019842e-04 + 2.276881081822984e-04 2.264310006278554e-04 2.251790095285085e-04 2.239321211178975e-04 2.226903224828012e-04 + 2.214536025966827e-04 2.202219483393713e-04 2.189953459440866e-04 2.177737827672056e-04 2.165572463172210e-04 + 2.153457236927424e-04 2.141392010208329e-04 2.129376661694288e-04 2.117411078009580e-04 2.105495123800498e-04 + 2.093628666254358e-04 2.081811579562958e-04 2.070043738711933e-04 2.058325011765904e-04 2.046655262979033e-04 + 2.035034378928387e-04 2.023462239716796e-04 2.011938707312936e-04 2.000463653117907e-04 1.989036953143001e-04 + 1.977658482429478e-04 1.966328105707422e-04 1.955045692837424e-04 1.943811134060168e-04 1.932624302421221e-04 + 1.921485062157297e-04 1.910393287336514e-04 1.899348854684124e-04 1.888351638115297e-04 1.877401500482506e-04 + 1.866498319949601e-04 1.855641985831636e-04 1.844832365124926e-04 1.834069326310023e-04 1.823352746298841e-04 + 1.812682501147551e-04 1.802058461455679e-04 1.791480493724017e-04 1.780948483852737e-04 1.770462314872484e-04 + 1.760021851824818e-04 1.749626967491274e-04 1.739277539439587e-04 1.728973444305181e-04 1.718714550470096e-04 + 1.708500728855944e-04 1.698331869571933e-04 1.688207849549946e-04 1.678128535713188e-04 1.668093803524777e-04 + 1.658103531111011e-04 1.648157594964937e-04 1.638255861976382e-04 1.628398210066413e-04 1.618584529166454e-04 + 1.608814690931768e-04 1.599088565742865e-04 1.589406031206167e-04 1.579766966509897e-04 1.570171246224424e-04 + 1.560618738321770e-04 1.551109328208930e-04 1.541642902068764e-04 1.532219328717612e-04 1.522838482661923e-04 + 1.513500243337891e-04 1.504204489591066e-04 1.494951093483970e-04 1.485739927662749e-04 1.476570882997282e-04 + 1.467443839796364e-04 1.458358667202351e-04 1.449315243896633e-04 1.440313449862068e-04 1.431353162531848e-04 + 1.422434254066872e-04 1.413556604013758e-04 1.404720102486319e-04 1.395924625558734e-04 1.387170046489957e-04 + 1.378456244430427e-04 1.369783100559194e-04 1.361150493062282e-04 1.352558293490397e-04 1.344006387024136e-04 + 1.335494662293593e-04 1.327022993333140e-04 1.318591256583063e-04 1.310199332689028e-04 1.301847103692820e-04 + 1.293534446013900e-04 1.285261234477974e-04 1.277027359881715e-04 1.268832706365997e-04 1.260677147052468e-04 + 1.252560562359565e-04 1.244482834803957e-04 1.236443845356053e-04 1.228443469528238e-04 1.220481588198588e-04 + 1.212558093699401e-04 1.204672865809282e-04 1.196825780471873e-04 1.189016720308052e-04 1.181245568536085e-04 + 1.173512205995857e-04 1.165816508484800e-04 1.158158362776897e-04 1.150537660210759e-04 1.142954277590100e-04 + 1.135408094568152e-04 1.127898995954114e-04 1.120426864956402e-04 1.112991581353023e-04 1.105593024093304e-04 + 1.098231085283700e-04 1.090905652465313e-04 1.083616601800625e-04 1.076363816399760e-04 1.069147182196831e-04 + 1.061966583782502e-04 1.054821899944032e-04 1.047713013150353e-04 1.040639818640637e-04 1.033602200082437e-04 + 1.026600035826387e-04 1.019633211976323e-04 1.012701615275282e-04 1.005805130149820e-04 9.989436355203399e-05 + 9.921170194739147e-05 9.853251765411631e-05 9.785679881782247e-05 9.718453366352614e-05 9.651571091087277e-05 + 9.585031930594751e-05 9.518834724915350e-05 9.452978284703146e-05 9.387461543789448e-05 9.322283420353250e-05 + 9.257442723618249e-05 9.192938310286574e-05 9.128769066247626e-05 9.064933872161225e-05 9.001431561187756e-05 + 8.938260983500139e-05 8.875421104519957e-05 8.812910809646098e-05 8.750728925694059e-05 8.688874335824857e-05 + 8.627345936363417e-05 8.566142611724158e-05 8.505263195150667e-05 8.444706587898619e-05 8.384471762172232e-05 + 8.324557578035348e-05 8.264962891132210e-05 8.205686604727953e-05 8.146727626544971e-05 8.088084838175318e-05 + 8.029757088191735e-05 7.971743327705584e-05 7.914042512047892e-05 7.856653495630607e-05 7.799575166346450e-05 + 7.742806441871695e-05 7.686346239245813e-05 7.630193435494130e-05 7.574346911053080e-05 7.518805653837606e-05 + 7.463568593117825e-05 7.408634594826592e-05 7.354002575090044e-05 7.299671464423979e-05 7.245640185167563e-05 + 7.191907614532941e-05 7.138472679150608e-05 7.085334380230530e-05 7.032491623916224e-05 6.979943301854977e-05 + 6.927688351841825e-05 6.875725716877753e-05 6.824054320182008e-05 6.772673050550591e-05 6.721580881996242e-05 + 6.670776807704407e-05 6.620259726868480e-05 6.570028562031883e-05 6.520082266140781e-05 6.470419793220322e-05 + 6.421040064958054e-05 6.371941996817583e-05 6.323124601185380e-05 6.274586851226631e-05 6.226327655003573e-05 + 6.178345963615301e-05 6.130640743984757e-05 6.083210957777482e-05 6.036055527561582e-05 5.989173409263222e-05 + 5.942563633391719e-05 5.896225154191688e-05 5.850156903007261e-05 5.804357852627766e-05 5.758826983099529e-05 + 5.713563260712647e-05 5.668565617514362e-05 5.623833053838233e-05 5.579364600051564e-05 5.535159201768813e-05 + 5.491215819134343e-05 5.447533442712218e-05 5.404111064124177e-05 5.360947650466450e-05 5.318042157160001e-05 + 5.275393622516995e-05 5.233001062811153e-05 5.190863431238880e-05 5.148979716458554e-05 5.107348923404401e-05 + 5.065970053025621e-05 5.024842074849432e-05 4.983963979263951e-05 4.943334827635427e-05 4.902953621108006e-05 + 4.862819332553702e-05 4.822930973793706e-05 4.783287562882953e-05 4.743888107972067e-05 4.704731588033618e-05 + 4.665817033540254e-05 4.627143510842172e-05 4.588710014690383e-05 4.550515545082771e-05 4.512559130332447e-05 + 4.474839802715817e-05 4.437356575264515e-05 4.400108444300858e-05 4.363094478314062e-05 4.326313737450849e-05 + 4.289765220307346e-05 4.253447954450777e-05 4.217360984935306e-05 4.181503354031293e-05 4.145874078526325e-05 + 4.110472186234567e-05 4.075296770939578e-05 4.040346881442376e-05 4.005621534517384e-05 3.971119780891244e-05 + 3.936840678851008e-05 3.902783280379881e-05 3.868946611492773e-05 3.835329736378580e-05 3.801931758461789e-05 + 3.768751721520911e-05 3.735788667634669e-05 3.703041665089796e-05 3.670509786268472e-05 3.638192090588934e-05 + 3.606087620758478e-05 3.574195476070656e-05 3.542514758568229e-05 3.511044516462031e-05 3.479783817623805e-05 + 3.448731747191980e-05 3.417887390941621e-05 3.387249813623169e-05 3.356818082938366e-05 3.326591326488256e-05 + 3.296568640239042e-05 3.266749086476883e-05 3.237131756688427e-05 3.207715751232477e-05 3.178500166911470e-05 + 3.149484077201404e-05 3.120666582870710e-05 3.092046825328168e-05 3.063623897047349e-05 3.035396883732847e-05 + 3.007364895961203e-05 2.979527048619034e-05 2.951882447255356e-05 2.924430180184470e-05 2.897169381596313e-05 + 2.870099196601076e-05 2.843218722351712e-05 2.816527069305565e-05 2.790023364581556e-05 2.763706736588794e-05 + 2.737576298520704e-05 2.711631161938774e-05 2.685870489191871e-05 2.660293422952212e-05 2.634899073350601e-05 + 2.609686574272242e-05 2.584655068622352e-05 2.559803697386157e-05 2.535131582907573e-05 2.510637865851451e-05 + 2.486321726016628e-05 2.462182305120829e-05 2.438218734168926e-05 2.414430166313400e-05 2.390815760058303e-05 + 2.367374667612129e-05 2.344106023464476e-05 2.321008999935892e-05 2.298082786356460e-05 2.275326527748312e-05 + 2.252739378233606e-05 2.230320509258137e-05 2.208069093512809e-05 2.185984291941186e-05 2.164065260635458e-05 + 2.142311199522572e-05 2.120721298028661e-05 2.099294714303281e-05 2.078030625998752e-05 2.056928220029127e-05 + 2.035986682231265e-05 2.015205183896797e-05 1.994582907956633e-05 1.974119073954575e-05 1.953812872162773e-05 + 1.933663479825456e-05 1.913670094979531e-05 1.893831919578259e-05 1.874148151575467e-05 1.854617976080873e-05 + 1.835240605058427e-05 1.816015268982217e-05 1.796941162992672e-05 1.778017486956627e-05 1.759243456762222e-05 + 1.740618289118282e-05 1.722141193137039e-05 1.703811372777776e-05 1.685628066375182e-05 1.667590509374455e-05 + 1.649697910104339e-05 1.631949489857415e-05 1.614344479286407e-05 1.596882111103627e-05 1.579561606259506e-05 + 1.562382191518076e-05 1.545343126338709e-05 1.528443649706141e-05 1.511682986511545e-05 1.495060379262073e-05 + 1.478575075387210e-05 1.462226320346460e-05 1.446013347627832e-05 1.429935410828208e-05 1.413991783947596e-05 + 1.398181711799591e-05 1.382504440087988e-05 1.366959229690567e-05 1.351545344207288e-05 1.336262041089977e-05 + 1.321108569966174e-05 1.306084210743495e-05 1.291188246012095e-05 1.276419932540445e-05 1.261778537439798e-05 + 1.247263337350260e-05 1.232873611168182e-05 1.218608628547451e-05 1.204467661277090e-05 1.190450010670460e-05 + 1.176554964839514e-05 1.162781797531038e-05 1.149129796332477e-05 1.135598253898601e-05 1.122186462622714e-05 + 1.108893706038782e-05 1.095719281332111e-05 1.082662505098182e-05 1.069722672643097e-05 1.056899077370047e-05 + 1.044191025341683e-05 1.031597825830204e-05 1.019118784797653e-05 1.006753201372614e-05 9.945003972957807e-06 + 9.823597003224701e-06 9.703304169766936e-06 9.584118614966616e-06 9.466033570975281e-06 9.349042284940899e-06 + 9.233137946012443e-06 9.118313747892748e-06 9.004563126071509e-06 8.891879438415634e-06 8.780255908737012e-06 + 8.669685879934477e-06 8.560162746518096e-06 8.451679906731882e-06 8.344230688978416e-06 8.237808513777729e-06 + 8.132406985376577e-06 8.028019552616531e-06 7.924639629701503e-06 7.822260741691212e-06 7.720876445763237e-06 + 7.620480284148957e-06 7.521065743540658e-06 7.422626477381218e-06 7.325156218634066e-06 7.228648532638821e-06 + 7.133097034958690e-06 7.038495423985100e-06 6.944837416133499e-06 6.852116691729515e-06 6.760326924607246e-06 + 6.669461983453847e-06 6.579515704432944e-06 6.490481806747385e-06 6.402354101863004e-06 6.315126452251840e-06 + 6.228792731669073e-06 6.143346764859859e-06 6.058782435540508e-06 5.975093791198315e-06 5.892274772590937e-06 + 5.810319279027480e-06 5.729221306547671e-06 5.648974882411472e-06 5.569574030477156e-06 5.491012732167998e-06 + 5.413285091010444e-06 5.336385298912571e-06 5.260307420244722e-06 5.185045547999291e-06 5.110593849728286e-06 + 5.036946516955677e-06 4.964097720721464e-06 4.892041619202182e-06 4.820772525961763e-06 4.750284753859853e-06 + 4.680572517390150e-06 4.611630102585562e-06 4.543451844884654e-06 4.476032095169469e-06 4.409365173309600e-06 + 4.343445435493855e-06 4.278267378107974e-06 4.213825432046252e-06 4.150113986510229e-06 4.087127510654963e-06 + 4.024860505544460e-06 3.963307478207591e-06 3.902462905546128e-06 3.842321351732513e-06 3.782877469285005e-06 + 3.724125818875267e-06 3.666060976275786e-06 3.608677584308628e-06 3.551970310325800e-06 3.495933813913828e-06 + 3.440562742860537e-06 3.385851865026623e-06 3.331795968547279e-06 3.278389763636986e-06 3.225628015585682e-06 + 3.173505536483180e-06 3.122017155106099e-06 3.071157684657154e-06 3.020921961442045e-06 2.971304937503200e-06 + 2.922301530764381e-06 2.873906622400171e-06 2.826115159163556e-06 2.778922119160790e-06 2.732322492500433e-06 + 2.686311250918327e-06 2.640883427466542e-06 2.596034137909800e-06 2.551758437600915e-06 2.508051388712647e-06 + 2.464908112415978e-06 2.422323753722291e-06 2.380293459852445e-06 2.338812372063220e-06 2.297875719562253e-06 + 2.257478763762930e-06 2.217616712073996e-06 2.178284811840686e-06 2.139478353112250e-06 2.101192645402220e-06 + 2.063422994293474e-06 2.026164721213360e-06 1.989413239181793e-06 1.953163950788084e-06 1.917412231009713e-06 + 1.882153506609316e-06 1.847383234461138e-06 1.813096887995954e-06 1.779289933937322e-06 1.745957881749227e-06 + 1.713096313387221e-06 1.680700776153704e-06 1.648766820412035e-06 1.617290047665242e-06 1.586266083282953e-06 + 1.555690561349229e-06 1.525559115412809e-06 1.495867444877275e-06 1.466611286844381e-06 1.437786342321971e-06 + 1.409388342689011e-06 1.381413059137875e-06 1.353856283643994e-06 1.326713811980504e-06 1.299981452903499e-06 + 1.273655087535907e-06 1.247730601634883e-06 1.222203862466376e-06 1.197070780161529e-06 1.172327293218336e-06 + 1.147969358200551e-06 1.123992934949297e-06 1.100394014305713e-06 1.077168647815731e-06 1.054312872343777e-06 + 1.031822727943270e-06 1.009694299029158e-06 9.879236928228051e-07 9.665070295488333e-07 9.454404356909418e-07 + 9.247200854784831e-07 9.043421911847067e-07 8.843029477247774e-07 8.645985728173436e-07 8.452253193362285e-07 + 8.261794626052351e-07 8.074572875932502e-07 7.890550921071068e-07 7.709692301619030e-07 7.531960701353248e-07 + 7.357319715620587e-07 7.185733287203112e-07 7.017165630618881e-07 6.851581162834306e-07 6.688944388625421e-07 + 6.529220052598067e-07 6.372373411274385e-07 6.218369717692920e-07 6.067174274527125e-07 5.918752755194360e-07 + 5.773071063798692e-07 5.630095271034721e-07 5.489791556312369e-07 5.352126455394792e-07 5.217066864180125e-07 + 5.084579644193884e-07 4.954631845887763e-07 4.827190834887087e-07 4.702224204045173e-07 4.579699684713550e-07 + 4.459585154334098e-07 4.341848919935187e-07 4.226459485782965e-07 4.113385363883691e-07 4.002595352312233e-07 + 3.894058504065020e-07 3.787744086301839e-07 3.683621500987016e-07 3.581660355932383e-07 3.481830676805770e-07 + 3.384102581524441e-07 3.288446273745833e-07 3.194832275224818e-07 3.103231330843525e-07 3.013614373207315e-07 + 2.925952486098954e-07 2.840217031010630e-07 2.756379695267500e-07 2.674412234106971e-07 2.594286576386206e-07 + 2.515974937029081e-07 2.439449754383926e-07 2.364683632309526e-07 2.291649345383248e-07 2.220320002407473e-07 + 2.150668931442167e-07 2.082669548865648e-07 2.016295514473211e-07 1.951520727682157e-07 1.888319311586693e-07 + 1.826665552837694e-07 1.766533931743509e-07 1.707899271779558e-07 1.650736547045015e-07 1.595020857916059e-07 + 1.540727581256184e-07 1.487832309302349e-07 1.436310837043274e-07 1.386139140291348e-07 1.337293426531939e-07 + 1.289750194034745e-07 1.243486077550924e-07 1.198477884856861e-07 1.154702687444825e-07 1.112137774078364e-07 + 1.070760615754017e-07 1.030548878714015e-07 9.914804983102429e-08 9.535336319532080e-08 9.166865877274502e-08 + 8.809178921148019e-08 8.462062987184363e-08 8.125307865123530e-08 7.798705169188094e-08 7.482048486743137e-08 + 7.175134265372113e-08 6.877760756933380e-08 6.589727849023001e-08 6.310837918621049e-08 6.040895419177239e-08 + 5.779706919084610e-08 5.527080986023133e-08 5.282828275733461e-08 5.046762055622123e-08 4.818697371034567e-08 + 4.598451068334482e-08 4.385842456607357e-08 4.180692971968811e-08 3.982825980405518e-08 3.792066966127786e-08 + 3.608243718277188e-08 3.431186206040581e-08 3.260726312426322e-08 3.096697968233847e-08 2.938937298745983e-08 + 2.787282684203093e-08 2.641574418968914e-08 2.501654849393015e-08 2.367368813134603e-08 2.238563078881267e-08 + 2.115086344400587e-08 1.996789606940446e-08 1.883525886916157e-08 1.775150390948272e-08 1.671520402936120e-08 + 1.572495208680648e-08 1.477936511938296e-08 1.387707990026544e-08 1.301675220490221e-08 1.219706138041649e-08 + 1.141670750179082e-08 1.067441065312196e-08 9.968913113355902e-09 9.298978133402818e-09 8.663390331238368e-09 + 8.060955677291694e-09 7.490500025975069e-09 6.950870854385858e-09 6.440937996309972e-09 5.959590797852082e-09 + 5.505739944416565e-09 5.078318901633865e-09 4.676280806472903e-09 4.298600029449081e-09 3.944272776496124e-09 + 3.612315204086912e-09 3.301765808464261e-09 3.011683971683484e-09 2.741149022073358e-09 2.489263438950313e-09 + 2.255150010734707e-09 2.037951439802415e-09 1.836833426869985e-09 1.650981924522248e-09 1.479603458288696e-09 + 1.321927088896133e-09 1.177201927023745e-09 1.044698361371603e-09 9.237089042804517e-10 8.135457713165132e-10 + 7.135428727606122e-10 6.230561233086797e-10 5.414610837010692e-10 4.681552957722881e-10 4.025579739718386e-10 + 3.441080911031397e-10 2.922668865200973e-10 2.465167169238545e-10 2.063598966733955e-10 1.713213823559041e-10 + 1.409467301732644e-10 1.148017117805301e-10 9.247489436372923e-11 7.357503403670199e-11 5.773147403071901e-11 + 4.459623415664643e-11 3.384125546419585e-11 2.515956035071991e-11 1.826656159304613e-11 1.289741553721677e-11 + 8.808852910154413e-12 5.779611749592996e-12 3.608107240050744e-12 2.114775563702074e-12 1.141629414770904e-12 + 5.504076981088132e-13 2.252028793998774e-13 7.135404618680312e-14 1.400208835054596e-14 2.858282411901289e-16 + 0.000000000000000e+00 3.280907692410757e+00 6.559093802140417e+00 9.834554467967374e+00 1.310728583537977e+01 + 1.637728405657552e+01 1.964454529046227e+01 2.290906570265743e+01 2.617084146548816e+01 2.942986875799139e+01 + 3.268614376591378e+01 3.593966268171175e+01 3.919042170455148e+01 4.243841704030890e+01 4.568364490156970e+01 + 4.892610150762930e+01 5.216578308449292e+01 5.540268586487547e+01 5.863680608820168e+01 6.186814000060598e+01 + 6.509668385493259e+01 6.832243391073550e+01 7.154538643427834e+01 7.476553769853463e+01 7.798288398318758e+01 + 8.119742157463018e+01 8.440914676596513e+01 8.761805585700493e+01 9.082414515427180e+01 9.402741097099775e+01 + 9.722784962712448e+01 1.004254574493035e+02 1.036202307708961e+02 1.068121659319733e+02 1.100012592793157e+02 + 1.131875071664140e+02 1.163709059534683e+02 1.195514520073887e+02 1.227291417017950e+02 1.259039714170167e+02 + 1.290759375400930e+02 1.322450364647731e+02 1.354112645915156e+02 1.385746183274891e+02 1.417350940865720e+02 + 1.448926882893522e+02 1.480473973631275e+02 1.511992177419055e+02 1.543481458664036e+02 1.574941781840487e+02 + 1.606373111489777e+02 1.637775412220371e+02 1.669148648707833e+02 1.700492785694823e+02 1.731807787991100e+02 + 1.763093620473519e+02 1.794350248086033e+02 1.825577635839695e+02 1.856775748812652e+02 1.887944552150149e+02 + 1.919084011064531e+02 1.950194090835239e+02 1.981274756808810e+02 2.012325974398883e+02 2.043347709086188e+02 + 2.074339926418558e+02 2.105302592010923e+02 2.136235671545306e+02 2.167139130770834e+02 2.198012935503726e+02 + 2.228857051627302e+02 2.259671445091978e+02 2.290456081915269e+02 2.321210928181784e+02 2.351935950043234e+02 + 2.382631113718425e+02 2.413296385493261e+02 2.443931731720744e+02 2.474537118820972e+02 2.505112513281143e+02 + 2.535657881655549e+02 2.566173190565586e+02 2.596658406699738e+02 2.627113496813596e+02 2.657538427729843e+02 + 2.687933166338259e+02 2.718297679595726e+02 2.748631934526219e+02 2.778935898220815e+02 2.809209537837683e+02 + 2.839452820602094e+02 2.869665713806416e+02 2.899848184810112e+02 2.930000201039745e+02 2.960121729988974e+02 + 2.990212739218558e+02 3.020273196356349e+02 3.050303069097302e+02 3.080302325203465e+02 3.110270932503987e+02 + 3.140208858895110e+02 3.170116072340180e+02 3.199992540869634e+02 3.229838232581013e+02 3.259653115638948e+02 + 3.289437158275174e+02 3.319190328788521e+02 3.348912595544916e+02 3.378603926977383e+02 3.408264291586049e+02 + 3.437893657938130e+02 3.467491994667945e+02 3.497059270476910e+02 3.526595454133537e+02 3.556100514473437e+02 + 3.585574420399318e+02 3.615017140880985e+02 3.644428644955341e+02 3.673808901726388e+02 3.703157880365222e+02 + 3.732475550110041e+02 3.761761880266134e+02 3.791016840205897e+02 3.820240399368814e+02 3.849432527261474e+02 + 3.878593193457557e+02 3.907722367597846e+02 3.936820019390219e+02 3.965886118609651e+02 3.994920635098217e+02 + 4.023923538765087e+02 4.052894799586530e+02 4.081834387605912e+02 4.110742272933696e+02 4.139618425747443e+02 + 4.168462816291812e+02 4.197275414878559e+02 4.226056191886540e+02 4.254805117761704e+02 4.283522163017099e+02 + 4.312207298232872e+02 4.340860494056267e+02 4.369481721201628e+02 4.398070950450389e+02 4.426628152651090e+02 + 4.455153298719365e+02 4.483646359637945e+02 4.512107306456656e+02 4.540536110292430e+02 4.568932742329288e+02 + 4.597297173818351e+02 4.625629376077841e+02 4.653929320493071e+02 4.682196978516460e+02 4.710432321667516e+02 + 4.738635321532851e+02 4.766805949766169e+02 4.794944178088276e+02 4.823049978287075e+02 4.851123322217564e+02 + 4.879164181801841e+02 4.907172529029099e+02 4.935148335955632e+02 4.963091574704831e+02 4.991002217467178e+02 + 5.018880236500261e+02 5.046725604128764e+02 5.074538292744463e+02 5.102318274806237e+02 5.130065522840063e+02 + 5.157780009439010e+02 5.185461707263250e+02 5.213110589040049e+02 5.240726627563774e+02 5.268309795695885e+02 + 5.295860066364945e+02 5.323377412566609e+02 5.350861807363634e+02 5.378313223885873e+02 5.405731635330272e+02 + 5.433117014960885e+02 5.460469336108854e+02 5.487788572172420e+02 5.515074696616928e+02 5.542327682974811e+02 + 5.569547504845609e+02 5.596734135895950e+02 5.623887549859570e+02 5.651007720537292e+02 5.678094621797045e+02 + 5.705148227573850e+02 5.732168511869830e+02 5.759155448754203e+02 5.786109012363282e+02 5.813029176900482e+02 + 5.839915916636313e+02 5.866769205908384e+02 5.893589019121401e+02 5.920375330747167e+02 5.947128115324583e+02 + 5.973847347459648e+02 6.000533001825459e+02 6.027185053162206e+02 6.053803476277183e+02 6.080388246044777e+02 + 6.106939337406476e+02 6.133456725370861e+02 6.159940385013617e+02 6.186390291477520e+02 6.212806419972447e+02 + 6.239188745775372e+02 6.265537244230364e+02 6.291851890748597e+02 6.318132660808333e+02 6.344379529954938e+02 + 6.370592473800871e+02 6.396771468025696e+02 6.422916488376064e+02 6.449027510665734e+02 6.475104510775553e+02 + 6.501147464653474e+02 6.527156348314542e+02 6.553131137840901e+02 6.579071809381794e+02 6.604978339153558e+02 + 6.630850703439634e+02 6.656688878590552e+02 6.682492841023947e+02 6.708262567224546e+02 6.733998033744177e+02 + 6.759699217201766e+02 6.785366094283333e+02 6.810998641742000e+02 6.836596836397980e+02 6.862160655138592e+02 + 6.887690074918247e+02 6.913185072758453e+02 6.938645625747821e+02 6.964071711042051e+02 6.989463305863949e+02 + 7.014820387503412e+02 7.040142933317441e+02 7.065430920730126e+02 7.090684327232666e+02 7.115903130383348e+02 + 7.141087307807558e+02 7.166236837197782e+02 7.191351696313601e+02 7.216431862981700e+02 7.241477315095852e+02 + 7.266488030616937e+02 7.291463987572921e+02 7.316405164058881e+02 7.341311538236981e+02 7.366183088336488e+02 + 7.391019792653765e+02 7.415821629552270e+02 7.440588577462564e+02 7.465320614882301e+02 7.490017720376235e+02 + 7.514679872576214e+02 7.539307050181191e+02 7.563899231957208e+02 7.588456396737411e+02 7.612978523422037e+02 + 7.637465590978424e+02 7.661917578441014e+02 7.686334464911333e+02 7.710716229558018e+02 7.735062851616793e+02 + 7.759374310390485e+02 7.783650585249019e+02 7.807891655629417e+02 7.832097501035795e+02 7.856268101039369e+02 + 7.880403435278453e+02 7.904503483458460e+02 7.928568225351897e+02 7.952597640798369e+02 7.976591709704585e+02 + 8.000550412044341e+02 8.024473727858536e+02 8.048361637255169e+02 8.072214120409334e+02 8.096031157563222e+02 + 8.119812729026120e+02 8.143558815174417e+02 8.167269396451593e+02 8.190944453368236e+02 8.214583966502021e+02 + 8.238187916497725e+02 8.261756284067224e+02 8.285289049989487e+02 8.308786195110586e+02 8.332247700343684e+02 + 8.355673546669050e+02 8.379063715134042e+02 8.402418186853124e+02 8.425736943007848e+02 8.449019964846872e+02 + 8.472267233685945e+02 8.495478730907921e+02 8.518654437962743e+02 8.541794336367457e+02 8.564898407706205e+02 + 8.587966633630226e+02 8.610998995857861e+02 8.633995476174539e+02 8.656956056432798e+02 8.679880718552264e+02 + 8.702769444519665e+02 8.725622216388828e+02 8.748439016280670e+02 8.771219826383219e+02 8.793964628951586e+02 + 8.816673406307990e+02 8.839346140841741e+02 8.861982815009252e+02 8.884583411334027e+02 8.907147912406675e+02 + 8.929676300884897e+02 8.952168559493493e+02 8.974624671024361e+02 8.997044618336495e+02 9.019428384355992e+02 + 9.041775952076036e+02 9.064087304556922e+02 9.086362424926032e+02 9.108601296377846e+02 9.130803902173951e+02 + 9.152970225643020e+02 9.175100250180832e+02 9.197193959250255e+02 9.219251336381268e+02 9.241272365170935e+02 + 9.263257029283417e+02 9.285205312449986e+02 9.307117198468995e+02 9.328992671205907e+02 9.350831714593277e+02 + 9.372634312630761e+02 9.394400449385104e+02 9.416130108990160e+02 9.437823275646871e+02 9.459479933623287e+02 + 9.481100067254541e+02 9.502683660942876e+02 9.524230699157629e+02 9.545741166435229e+02 9.567215047379214e+02 + 9.588652326660207e+02 9.610052989015940e+02 9.631417019251231e+02 9.652744402238004e+02 9.674035122915279e+02 + 9.695289166289172e+02 9.716506517432896e+02 9.737687161486764e+02 9.758831083658184e+02 9.779938269221661e+02 + 9.801008703518804e+02 9.822042371958310e+02 9.843039260015983e+02 9.863999353234714e+02 9.884922637224498e+02 + 9.905809097662435e+02 9.926658720292703e+02 9.947471490926598e+02 9.968247395442500e+02 9.988986419785891e+02 + 1.000968854996935e+03 1.003035377207256e+03 1.005098207224229e+03 1.007157343669241e+03 1.009212785170389e+03 + 1.011264530362480e+03 1.013312577887031e+03 1.015356926392268e+03 1.017397574533126e+03 1.019434520971252e+03 + 1.021467764375000e+03 1.023497303419437e+03 1.025523136786337e+03 1.027545263164185e+03 1.029563681248175e+03 + 1.031578389740212e+03 1.033589387348909e+03 1.035596672789591e+03 1.037600244784291e+03 1.039600102061752e+03 + 1.041596243357428e+03 1.043588667413480e+03 1.045577372978782e+03 1.047562358808916e+03 1.049543623666173e+03 + 1.051521166319557e+03 1.053494985544777e+03 1.055465080124256e+03 1.057431448847125e+03 1.059394090509224e+03 + 1.061353003913104e+03 1.063308187868025e+03 1.065259641189957e+03 1.067207362701581e+03 1.069151351232285e+03 + 1.071091605618170e+03 1.073028124702043e+03 1.074960907333424e+03 1.076889952368542e+03 1.078815258670335e+03 + 1.080736825108451e+03 1.082654650559248e+03 1.084568733905793e+03 1.086479074037864e+03 1.088385669851947e+03 + 1.090288520251241e+03 1.092187624145651e+03 1.094082980451794e+03 1.095974588092995e+03 1.097862445999292e+03 + 1.099746553107428e+03 1.101626908360861e+03 1.103503510709754e+03 1.105376359110983e+03 1.107245452528133e+03 + 1.109110789931497e+03 1.110972370298081e+03 1.112830192611597e+03 1.114684255862470e+03 1.116534559047833e+03 + 1.118381101171529e+03 1.120223881244111e+03 1.122062898282842e+03 1.123898151311694e+03 1.125729639361349e+03 + 1.127557361469200e+03 1.129381316679347e+03 1.131201504042604e+03 1.133017922616489e+03 1.134830571465235e+03 + 1.136639449659783e+03 1.138444556277782e+03 1.140245890403593e+03 1.142043451128286e+03 1.143837237549640e+03 + 1.145627248772146e+03 1.147413483907002e+03 1.149195942072117e+03 1.150974622392110e+03 1.152749523998310e+03 + 1.154520646028755e+03 1.156287987628192e+03 1.158051547948079e+03 1.159811326146585e+03 1.161567321388586e+03 + 1.163319532845669e+03 1.165067959696131e+03 1.166812601124979e+03 1.168553456323928e+03 1.170290524491405e+03 + 1.172023804832545e+03 1.173753296559195e+03 1.175478998889909e+03 1.177200911049953e+03 1.178919032271301e+03 + 1.180633361792637e+03 1.182343898859357e+03 1.184050642723563e+03 1.185753592644071e+03 1.187452747886402e+03 + 1.189148107722792e+03 1.190839671432183e+03 1.192527438300227e+03 1.194211407619287e+03 1.195891578688435e+03 + 1.197567950813455e+03 1.199240523306837e+03 1.200909295487783e+03 1.202574266682204e+03 1.204235436222721e+03 + 1.205892803448666e+03 1.207546367706079e+03 1.209196128347710e+03 1.210842084733019e+03 1.212484236228177e+03 + 1.214122582206062e+03 1.215757122046265e+03 1.217387855135084e+03 1.219014780865528e+03 1.220637898637316e+03 + 1.222257207856876e+03 1.223872707937346e+03 1.225484398298575e+03 1.227092278367119e+03 1.228696347576247e+03 + 1.230296605365935e+03 1.231893051182870e+03 1.233485684480449e+03 1.235074504718779e+03 1.236659511364675e+03 + 1.238240703891664e+03 1.239818081779981e+03 1.241391644516571e+03 1.242961391595090e+03 1.244527322515903e+03 + 1.246089436786084e+03 1.247647733919417e+03 1.249202213436398e+03 1.250752874864230e+03 1.252299717736826e+03 + 1.253842741594810e+03 1.255381945985516e+03 1.256917330462986e+03 1.258448894587972e+03 1.259976637927938e+03 + 1.261500560057056e+03 1.263020660556207e+03 1.264536939012984e+03 1.266049395021687e+03 1.267558028183329e+03 + 1.269062838105629e+03 1.270563824403019e+03 1.272060986696640e+03 1.273554324614341e+03 1.275043837790682e+03 + 1.276529525866934e+03 1.278011388491075e+03 1.279489425317796e+03 1.280963636008494e+03 1.282434020231280e+03 + 1.283900577660971e+03 1.285363307979095e+03 1.286822210873891e+03 1.288277286040307e+03 1.289728533179999e+03 + 1.291175952001336e+03 1.292619542219393e+03 1.294059303555960e+03 1.295495235739530e+03 1.296927338505312e+03 + 1.298355611595221e+03 1.299780054757883e+03 1.301200667748633e+03 1.302617450329516e+03 1.304030402269289e+03 + 1.305439523343415e+03 1.306844813334069e+03 1.308246272030136e+03 1.309643899227210e+03 1.311037694727594e+03 + 1.312427658340302e+03 1.313813789881058e+03 1.315196089172293e+03 1.316574556043153e+03 1.317949190329488e+03 + 1.319319991873862e+03 1.320686960525546e+03 1.322050096140523e+03 1.323409398581483e+03 1.324764867717829e+03 + 1.326116503425671e+03 1.327464305587830e+03 1.328808274093838e+03 1.330148408839934e+03 1.331484709729068e+03 + 1.332817176670901e+03 1.334145809581802e+03 1.335470608384850e+03 1.336791573009835e+03 1.338108703393256e+03 + 1.339421999478320e+03 1.340731461214948e+03 1.342037088559766e+03 1.343338881476113e+03 1.344636839934036e+03 + 1.345930963910293e+03 1.347221253388351e+03 1.348507708358388e+03 1.349790328817288e+03 1.351069114768650e+03 + 1.352344066222779e+03 1.353615183196692e+03 1.354882465714113e+03 1.356145913805479e+03 1.357405527507935e+03 + 1.358661306865335e+03 1.359913251928245e+03 1.361161362753938e+03 1.362405639406399e+03 1.363646081956323e+03 + 1.364882690481112e+03 1.366115465064880e+03 1.367344405798451e+03 1.368569512779358e+03 1.369790786111843e+03 + 1.371008225906858e+03 1.372221832282067e+03 1.373431605361840e+03 1.374637545277261e+03 1.375839652166119e+03 + 1.377037926172918e+03 1.378232367448867e+03 1.379422976151887e+03 1.380609752446609e+03 1.381792696504374e+03 + 1.382971808503231e+03 1.384147088627939e+03 1.385318537069970e+03 1.386486154027501e+03 1.387649939705423e+03 + 1.388809894315333e+03 1.389966018075540e+03 1.391118311211063e+03 1.392266773953630e+03 1.393411406541678e+03 + 1.394552209220356e+03 1.395689182241520e+03 1.396822325863737e+03 1.397951640352285e+03 1.399077125979150e+03 + 1.400198783023028e+03 1.401316611769325e+03 1.402430612510158e+03 1.403540785544351e+03 1.404647131177441e+03 + 1.405749649721672e+03 1.406848341496000e+03 1.407943206826088e+03 1.409034246044311e+03 1.410121459489754e+03 + 1.411204847508209e+03 1.412284410452182e+03 1.413360148680885e+03 1.414432062560241e+03 1.415500152462884e+03 + 1.416564418768155e+03 1.417624861862108e+03 1.418681482137504e+03 1.419734279993815e+03 1.420783255837224e+03 + 1.421828410080621e+03 1.422869743143608e+03 1.423907255452495e+03 1.424940947440303e+03 1.425970819546763e+03 + 1.426996872218314e+03 1.428019105908108e+03 1.429037521076003e+03 1.430052118188569e+03 1.431062897719085e+03 + 1.432069860147540e+03 1.433073005960632e+03 1.434072335651771e+03 1.435067849721075e+03 1.436059548675370e+03 + 1.437047433028196e+03 1.438031503299800e+03 1.439011760017138e+03 1.439988203713878e+03 1.440960834930396e+03 + 1.441929654213780e+03 1.442894662117825e+03 1.443855859203037e+03 1.444813246036631e+03 1.445766823192535e+03 + 1.446716591251382e+03 1.447662550800518e+03 1.448604702433997e+03 1.449543046752585e+03 1.450477584363755e+03 + 1.451408315881691e+03 1.452335241927287e+03 1.453258363128147e+03 1.454177680118583e+03 1.455093193539620e+03 + 1.456004904038989e+03 1.456912812271134e+03 1.457816918897206e+03 1.458717224585068e+03 1.459613730009291e+03 + 1.460506435851157e+03 1.461395342798658e+03 1.462280451546494e+03 1.463161762796076e+03 1.464039277255525e+03 + 1.464912995639670e+03 1.465782918670054e+03 1.466649047074924e+03 1.467511381589240e+03 1.468369922954673e+03 + 1.469224671919600e+03 1.470075629239112e+03 1.470922795675006e+03 1.471766171995790e+03 1.472605758976684e+03 + 1.473441557399614e+03 1.474273568053219e+03 1.475101791732846e+03 1.475926229240551e+03 1.476746881385102e+03 + 1.477563748981976e+03 1.478376832853358e+03 1.479186133828146e+03 1.479991652741944e+03 1.480793390437068e+03 + 1.481591347762545e+03 1.482385525574108e+03 1.483175924734204e+03 1.483962546111986e+03 1.484745390583318e+03 + 1.485524459030776e+03 1.486299752343644e+03 1.487071271417914e+03 1.487839017156289e+03 1.488602990468185e+03 + 1.489363192269722e+03 1.490119623483735e+03 1.490872285039765e+03 1.491621177874064e+03 1.492366302929595e+03 + 1.493107661156030e+03 1.493845253509749e+03 1.494579080953843e+03 1.495309144458115e+03 1.496035444999074e+03 + 1.496757983559942e+03 1.497476761130647e+03 1.498191778707831e+03 1.498903037294843e+03 1.499610537901742e+03 + 1.500314281545298e+03 1.501014269248990e+03 1.501710502043006e+03 1.502402980964245e+03 1.503091707056315e+03 + 1.503776681369534e+03 1.504457904960931e+03 1.505135378894241e+03 1.505809104239914e+03 1.506479082075105e+03 + 1.507145313483682e+03 1.507807799556220e+03 1.508466541390007e+03 1.509121540089038e+03 1.509772796764020e+03 + 1.510420312532367e+03 1.511064088518205e+03 1.511704125852369e+03 1.512340425672404e+03 1.512972989122564e+03 + 1.513601817353814e+03 1.514226911523828e+03 1.514848272796989e+03 1.515465902344391e+03 1.516079801343838e+03 + 1.516689970979842e+03 1.517296412443626e+03 1.517899126933124e+03 1.518498115652977e+03 1.519093379814537e+03 + 1.519684920635866e+03 1.520272739341736e+03 1.520856837163628e+03 1.521437215339733e+03 1.522013875114953e+03 + 1.522586817740897e+03 1.523156044475887e+03 1.523721556584951e+03 1.524283355339831e+03 1.524841442018975e+03 + 1.525395817907543e+03 1.525946484297405e+03 1.526493442487138e+03 1.527036693782033e+03 1.527576239494086e+03 + 1.528112080942007e+03 1.528644219451213e+03 1.529172656353831e+03 1.529697392988700e+03 1.530218430701367e+03 + 1.530735770844087e+03 1.531249414775829e+03 1.531759363862268e+03 1.532265619475790e+03 1.532768182995492e+03 + 1.533267055807180e+03 1.533762239303368e+03 1.534253734883281e+03 1.534741543952856e+03 1.535225667924735e+03 + 1.535706108218275e+03 1.536182866259539e+03 1.536655943481301e+03 1.537125341323045e+03 1.537591061230964e+03 + 1.538053104657961e+03 1.538511473063650e+03 1.538966167914353e+03 1.539417190683102e+03 1.539864542849641e+03 + 1.540308225900420e+03 1.540748241328602e+03 1.541184590634058e+03 1.541617275323370e+03 1.542046296909827e+03 + 1.542471656913432e+03 1.542893356860894e+03 1.543311398285634e+03 1.543725782727782e+03 1.544136511734178e+03 + 1.544543586858370e+03 1.544947009660620e+03 1.545346781707894e+03 1.545742904573873e+03 1.546135379838945e+03 + 1.546524209090207e+03 1.546909393921469e+03 1.547290935933248e+03 1.547668836732771e+03 1.548043097933976e+03 + 1.548413721157510e+03 1.548780708030729e+03 1.549144060187701e+03 1.549503779269201e+03 1.549859866922715e+03 + 1.550212324802440e+03 1.550561154569281e+03 1.550906357890854e+03 1.551247936441483e+03 1.551585891902203e+03 + 1.551920225960758e+03 1.552250940311604e+03 1.552578036655905e+03 1.552901516701533e+03 1.553221382163073e+03 + 1.553537634761818e+03 1.553850276225772e+03 1.554159308289647e+03 1.554464732694865e+03 1.554766551189559e+03 + 1.555064765528572e+03 1.555359377473454e+03 1.555650388792468e+03 1.555937801260586e+03 1.556221616659488e+03 + 1.556501836777564e+03 1.556778463409917e+03 1.557051498358356e+03 1.557320943431401e+03 1.557586800444283e+03 + 1.557849071218940e+03 1.558107757584023e+03 1.558362861374890e+03 1.558614384433611e+03 1.558862328608964e+03 + 1.559106695756438e+03 1.559347487738230e+03 1.559584706423249e+03 1.559818353687112e+03 1.560048431412147e+03 + 1.560274941487391e+03 1.560497885808591e+03 1.560717266278204e+03 1.560933084805396e+03 1.561145343306044e+03 + 1.561354043702732e+03 1.561559187924758e+03 1.561760777908126e+03 1.561958815595552e+03 1.562153302936461e+03 + 1.562344241886987e+03 1.562531634409975e+03 1.562715482474979e+03 1.562895788058264e+03 1.563072553142803e+03 + 1.563245779718279e+03 1.563415469781085e+03 1.563581625334326e+03 1.563744248387813e+03 1.563903340958068e+03 + 1.564058905068325e+03 1.564210942748526e+03 1.564359456035321e+03 1.564504446972073e+03 1.564645917608853e+03 + 1.564783870002442e+03 1.564918306216331e+03 1.565049228320720e+03 1.565176638392519e+03 1.565300538515349e+03 + 1.565420930779540e+03 1.565537817282130e+03 1.565651200126870e+03 1.565761081424219e+03 1.565867463291344e+03 + 1.565970347852125e+03 1.566069737237150e+03 1.566165633583717e+03 1.566258039035835e+03 1.566346955744220e+03 + 1.566432385866300e+03 1.566514331566212e+03 1.566592795014803e+03 1.566667778389629e+03 1.566739283874957e+03 + 1.566807313661764e+03 1.566871869947734e+03 1.566932954937263e+03 1.566990570841457e+03 1.567044719878131e+03 + 1.567095404271811e+03 1.567142626253729e+03 1.567186388061831e+03 1.567226691940771e+03 1.567263540141913e+03 + 1.567296934923331e+03 1.567326878549808e+03 1.567353373292836e+03 1.567376421430620e+03 1.567396025248071e+03 + 1.567412187036812e+03 1.567424909095176e+03 1.567434193728203e+03 1.567440043247646e+03 1.567442459971967e+03 + 1.567441446226336e+03 1.567437004342634e+03 1.567429136659453e+03 1.567417845522091e+03 1.567403133282561e+03 + 1.567385002299581e+03 1.567363454938582e+03 1.567338493571702e+03 1.567310120577791e+03 1.567278338342408e+03 + 1.567243149257822e+03 1.567204555723011e+03 1.567162560143663e+03 1.567117164932177e+03 1.567068372507660e+03 + 1.567016185295929e+03 1.566960605729512e+03 1.566901636247646e+03 1.566839279296277e+03 1.566773537328063e+03 + 1.566704412802369e+03 1.566631908185271e+03 1.566556025949555e+03 1.566476768574717e+03 1.566394138546961e+03 + 1.566308138359204e+03 1.566218770511069e+03 1.566126037508891e+03 1.566029941865714e+03 1.565930486101294e+03 + 1.565827672742092e+03 1.565721504321283e+03 1.565611983378751e+03 1.565499112461087e+03 1.565382894121595e+03 + 1.565263330920288e+03 1.565140425423888e+03 1.565014180205826e+03 1.564884597846246e+03 1.564751680931997e+03 + 1.564615432056643e+03 1.564475853820452e+03 1.564332948830408e+03 1.564186719700199e+03 1.564037169050227e+03 + 1.563884299507601e+03 1.563728113706142e+03 1.563568614286379e+03 1.563405803895550e+03 1.563239685187607e+03 + 1.563070260823207e+03 1.562897533469719e+03 1.562721505801220e+03 1.562542180498501e+03 1.562359560249057e+03 + 1.562173647747097e+03 1.561984445693539e+03 1.561791956796009e+03 1.561596183768845e+03 1.561397129333092e+03 + 1.561194796216507e+03 1.560989187153558e+03 1.560780304885418e+03 1.560568152159974e+03 1.560352731731822e+03 + 1.560134046362267e+03 1.559912098819323e+03 1.559686891877715e+03 1.559458428318879e+03 1.559226710930956e+03 + 1.558991742508803e+03 1.558753525853981e+03 1.558512063774766e+03 1.558267359086140e+03 1.558019414609795e+03 + 1.557768233174136e+03 1.557513817614273e+03 1.557256170772030e+03 1.556995295495938e+03 1.556731194641239e+03 + 1.556463871069885e+03 1.556193327650536e+03 1.555919567258564e+03 1.555642592776049e+03 1.555362407091783e+03 + 1.555079013101264e+03 1.554792413706704e+03 1.554502611817021e+03 1.554209610347846e+03 1.553913412221517e+03 + 1.553614020367084e+03 1.553311437720305e+03 1.553005667223649e+03 1.552696711826295e+03 1.552384574484129e+03 + 1.552069258159750e+03 1.551750765822466e+03 1.551429100448294e+03 1.551104265019960e+03 1.550776262526902e+03 + 1.550445095965265e+03 1.550110768337907e+03 1.549773282654394e+03 1.549432641931000e+03 1.549088849190713e+03 + 1.548741907463227e+03 1.548391819784946e+03 1.548038589198987e+03 1.547682218755173e+03 1.547322711510039e+03 + 1.546960070526829e+03 1.546594298875496e+03 1.546225399632705e+03 1.545853375881829e+03 1.545478230712950e+03 + 1.545099967222861e+03 1.544718588515066e+03 1.544334097699777e+03 1.543946497893915e+03 1.543555792221112e+03 + 1.543161983811711e+03 1.542765075802762e+03 1.542365071338026e+03 1.541961973567975e+03 1.541555785649789e+03 + 1.541146510747358e+03 1.540734152031283e+03 1.540318712678874e+03 1.539900195874149e+03 1.539478604807839e+03 + 1.539053942677383e+03 1.538626212686929e+03 1.538195418047336e+03 1.537761561976173e+03 1.537324647697717e+03 + 1.536884678442957e+03 1.536441657449592e+03 1.535995587962026e+03 1.535546473231378e+03 1.535094316515475e+03 + 1.534639121078853e+03 1.534180890192759e+03 1.533719627135150e+03 1.533255335190690e+03 1.532788017650757e+03 + 1.532317677813435e+03 1.531844318983518e+03 1.531367944472514e+03 1.530888557598635e+03 1.530406161686807e+03 + 1.529920760068664e+03 1.529432356082550e+03 1.528940953073517e+03 1.528446554393331e+03 1.527949163400464e+03 + 1.527448783460099e+03 1.526945417944129e+03 1.526439070231157e+03 1.525929743706494e+03 1.525417441762163e+03 + 1.524902167796895e+03 1.524383925216131e+03 1.523862717432025e+03 1.523338547863434e+03 1.522811419935932e+03 + 1.522281337081799e+03 1.521748302740024e+03 1.521212320356308e+03 1.520673393383061e+03 1.520131525279401e+03 + 1.519586719511159e+03 1.519038979550873e+03 1.518488308877793e+03 1.517934710977876e+03 1.517378189343791e+03 + 1.516818747474916e+03 1.516256388877339e+03 1.515691117063858e+03 1.515122935553979e+03 1.514551847873920e+03 + 1.513977857556607e+03 1.513400968141679e+03 1.512821183175479e+03 1.512238506211065e+03 1.511652940808203e+03 + 1.511064490533368e+03 1.510473158959745e+03 1.509878949667230e+03 1.509281866242427e+03 1.508681912278651e+03 + 1.508079091375926e+03 1.507473407140987e+03 1.506864863187277e+03 1.506253463134950e+03 1.505639210610869e+03 + 1.505022109248608e+03 1.504402162688449e+03 1.503779374577385e+03 1.503153748569118e+03 1.502525288324061e+03 + 1.501893997509335e+03 1.501259879798773e+03 1.500622938872914e+03 1.499983178419011e+03 1.499340602131025e+03 + 1.498695213709626e+03 1.498047016862194e+03 1.497396015302820e+03 1.496742212752304e+03 1.496085612938155e+03 + 1.495426219594593e+03 1.494764036462547e+03 1.494099067289655e+03 1.493431315830267e+03 1.492760785845442e+03 + 1.492087481102946e+03 1.491411405377259e+03 1.490732562449567e+03 1.490050956107769e+03 1.489366590146471e+03 + 1.488679468366991e+03 1.487989594577355e+03 1.487296972592300e+03 1.486601606233272e+03 1.485903499328426e+03 + 1.485202655712629e+03 1.484499079227457e+03 1.483792773721193e+03 1.483083743048834e+03 1.482371991072084e+03 + 1.481657521659358e+03 1.480940338685780e+03 1.480220446033183e+03 1.479497847590113e+03 1.478772547251821e+03 + 1.478044548920272e+03 1.477313856504138e+03 1.476580473918802e+03 1.475844405086357e+03 1.475105653935605e+03 + 1.474364224402058e+03 1.473620120427938e+03 1.472873345962177e+03 1.472123904960415e+03 1.471371801385004e+03 + 1.470617039205005e+03 1.469859622396187e+03 1.469099554941032e+03 1.468336840828730e+03 1.467571484055180e+03 + 1.466803488622991e+03 1.466032858541484e+03 1.465259597826687e+03 1.464483710501340e+03 1.463705200594890e+03 + 1.462924072143496e+03 1.462140329190026e+03 1.461353975784058e+03 1.460565015981880e+03 1.459773453846489e+03 + 1.458979293447591e+03 1.458182538861605e+03 1.457383194171656e+03 1.456581263467582e+03 1.455776750845927e+03 + 1.454969660409948e+03 1.454159996269611e+03 1.453347762541590e+03 1.452532963349272e+03 1.451715602822750e+03 + 1.450895685098830e+03 1.450073214321026e+03 1.449248194639563e+03 1.448420630211373e+03 1.447590525200101e+03 + 1.446757883776100e+03 1.445922710116434e+03 1.445085008404874e+03 1.444244782831905e+03 1.443402037594718e+03 + 1.442556776897215e+03 1.441709004950008e+03 1.440858725970420e+03 1.440005944182481e+03 1.439150663816933e+03 + 1.438292889111226e+03 1.437432624309523e+03 1.436569873662692e+03 1.435704641428314e+03 1.434836931870678e+03 + 1.433966749260786e+03 1.433094097876346e+03 1.432218982001777e+03 1.431341405928208e+03 1.430461373953479e+03 + 1.429578890382137e+03 1.428693959525441e+03 1.427806585701360e+03 1.426916773234569e+03 1.426024526456458e+03 + 1.425129849705122e+03 1.424232747325370e+03 1.423333223668719e+03 1.422431283093393e+03 1.421526929964331e+03 + 1.420620168653178e+03 1.419711003538289e+03 1.418799439004731e+03 1.417885479444278e+03 1.416969129255415e+03 + 1.416050392843337e+03 1.415129274619950e+03 1.414205779003866e+03 1.413279910420411e+03 1.412351673301618e+03 + 1.411421072086230e+03 1.410488111219700e+03 1.409552795154193e+03 1.408615128348581e+03 1.407675115268446e+03 + 1.406732760386080e+03 1.405788068180486e+03 1.404841043137375e+03 1.403891689749170e+03 1.402940012515001e+03 + 1.401986015940709e+03 1.401029704538846e+03 1.400071082828672e+03 1.399110155336157e+03 1.398146926593981e+03 + 1.397181401141535e+03 1.396213583524918e+03 1.395243478296938e+03 1.394271090017116e+03 1.393296423251680e+03 + 1.392319482573570e+03 1.391340272562432e+03 1.390358797804626e+03 1.389375062893219e+03 1.388389072427989e+03 + 1.387400831015423e+03 1.386410343268718e+03 1.385417613807782e+03 1.384422647259231e+03 1.383425448256391e+03 + 1.382426021439299e+03 1.381424371454700e+03 1.380420502956051e+03 1.379414420603515e+03 1.378406129063970e+03 + 1.377395633010999e+03 1.376382937124898e+03 1.375368046092671e+03 1.374350964608031e+03 1.373331697371403e+03 + 1.372310249089921e+03 1.371286624477428e+03 1.370260828254477e+03 1.369232865148331e+03 1.368202739892964e+03 + 1.367170457229056e+03 1.366136021904002e+03 1.365099438671902e+03 1.364060712293568e+03 1.363019847536522e+03 + 1.361976849174995e+03 1.360931721989928e+03 1.359884470768972e+03 1.358835100306487e+03 1.357783615403544e+03 + 1.356730020867921e+03 1.355674321514110e+03 1.354616522163310e+03 1.353556627643430e+03 1.352494642789090e+03 + 1.351430572441617e+03 1.350364421449050e+03 1.349296194666138e+03 1.348225896954338e+03 1.347153533181818e+03 + 1.346079108223457e+03 1.345002626960841e+03 1.343924094282267e+03 1.342843515082743e+03 1.341760894263984e+03 + 1.340676236734416e+03 1.339589547409177e+03 1.338500831210112e+03 1.337410093065776e+03 1.336317337911434e+03 + 1.335222570689062e+03 1.334125796347346e+03 1.333027019841677e+03 1.331926246134163e+03 1.330823480193616e+03 + 1.329718726995561e+03 1.328611991522230e+03 1.327503278762568e+03 1.326392593712228e+03 1.325279941373571e+03 + 1.324165326755672e+03 1.323048754874311e+03 1.321930230751983e+03 1.320809759417887e+03 1.319687345907936e+03 + 1.318562995264752e+03 1.317436712537665e+03 1.316308502782716e+03 1.315178371062656e+03 1.314046322446946e+03 + 1.312912362011755e+03 1.311776494839963e+03 1.310638726021160e+03 1.309499060651645e+03 1.308357503834428e+03 + 1.307214060679228e+03 1.306068736302473e+03 1.304921535827301e+03 1.303772464383560e+03 1.302621527107810e+03 + 1.301468729143317e+03 1.300314075640058e+03 1.299157571754721e+03 1.297999222650704e+03 1.296839033498112e+03 + 1.295677009473761e+03 1.294513155761180e+03 1.293347477550602e+03 1.292179980038974e+03 1.291010668429951e+03 + 1.289839547933899e+03 1.288666623767893e+03 1.287491901155716e+03 1.286315385327865e+03 1.285137081521542e+03 + 1.283956994980662e+03 1.282775130955849e+03 1.281591494704436e+03 1.280406091490466e+03 1.279218926584693e+03 + 1.278030005264579e+03 1.276839332814297e+03 1.275646914524728e+03 1.274452755693465e+03 1.273256861624810e+03 + 1.272059237629775e+03 1.270859889026079e+03 1.269658821138155e+03 1.268456039297144e+03 1.267251548840895e+03 + 1.266045355113969e+03 1.264837463467636e+03 1.263627879259876e+03 1.262416607855379e+03 1.261203654625543e+03 + 1.259989024948479e+03 1.258772724209004e+03 1.257554757798647e+03 1.256335131115646e+03 1.255113849564950e+03 + 1.253890918558217e+03 1.252666343513813e+03 1.251440129856817e+03 1.250212283019015e+03 1.248982808438904e+03 + 1.247751711561691e+03 1.246518997839292e+03 1.245284672730334e+03 1.244048741700151e+03 1.242811210220790e+03 + 1.241572083771006e+03 1.240331367836264e+03 1.239089067908740e+03 1.237845189487317e+03 1.236599738077590e+03 + 1.235352719191863e+03 1.234104138349150e+03 1.232854001075175e+03 1.231602312902370e+03 1.230349079369880e+03 + 1.229094306023557e+03 1.227837998415964e+03 1.226580162106373e+03 1.225320802660766e+03 1.224059925651835e+03 + 1.222797536658982e+03 1.221533641268318e+03 1.220268245072664e+03 1.219001353671552e+03 1.217732972671222e+03 + 1.216463107684624e+03 1.215191764331420e+03 1.213918948237977e+03 1.212644665037377e+03 1.211368920369408e+03 + 1.210091719880570e+03 1.208813069224072e+03 1.207532974059833e+03 1.206251440054480e+03 1.204968472881353e+03 + 1.203684078220499e+03 1.202398261758676e+03 1.201111029189351e+03 1.199822386212701e+03 1.198532338535615e+03 + 1.197240891871687e+03 1.195948051941225e+03 1.194653824471246e+03 1.193358215195474e+03 1.192061229854346e+03 + 1.190762874195007e+03 1.189463153971313e+03 1.188162074943828e+03 1.186859642879827e+03 1.185555863553295e+03 + 1.184250742744927e+03 1.182944286242125e+03 1.181636499839004e+03 1.180327389336388e+03 1.179016960541809e+03 + 1.177705219269511e+03 1.176392171340446e+03 1.175077822582277e+03 1.173762178829377e+03 1.172445245922827e+03 + 1.171127029710419e+03 1.169807536046655e+03 1.168486770792745e+03 1.167164739816612e+03 1.165841448992886e+03 + 1.164516904202907e+03 1.163191111334726e+03 1.161864076283103e+03 1.160535804949508e+03 1.159206303242120e+03 + 1.157875577075829e+03 1.156543632372233e+03 1.155210475059642e+03 1.153876111073074e+03 1.152540546354257e+03 + 1.151203786851631e+03 1.149865838520342e+03 1.148526707322247e+03 1.147186399225916e+03 1.145844920206624e+03 + 1.144502276246358e+03 1.143158473333815e+03 1.141813517464402e+03 1.140467414640234e+03 1.139120170870139e+03 + 1.137771792169650e+03 1.136422284561014e+03 1.135071654073185e+03 1.133719906741829e+03 1.132367048609320e+03 + 1.131013085724743e+03 1.129658024143891e+03 1.128301869929270e+03 1.126944629150092e+03 1.125586307882280e+03 + 1.124226912208469e+03 1.122866448218001e+03 1.121504922006928e+03 1.120142339678013e+03 1.118778707340729e+03 + 1.117414031111256e+03 1.116048317112488e+03 1.114681571474025e+03 1.113313800332179e+03 1.111945009829970e+03 + 1.110575206117129e+03 1.109204395350097e+03 1.107832583692024e+03 1.106459777312770e+03 1.105085982388904e+03 + 1.103711205103706e+03 1.102335451647166e+03 1.100958728215983e+03 1.099581041013564e+03 1.098202396250028e+03 + 1.096822800142205e+03 1.095442258913632e+03 1.094060778794555e+03 1.092678366021934e+03 1.091295026839436e+03 + 1.089910767497437e+03 1.088525594253023e+03 1.087139513369993e+03 1.085752531118851e+03 1.084364653776815e+03 + 1.082975887627809e+03 1.081586238962469e+03 1.080195714078142e+03 1.078804319278880e+03 1.077412060875450e+03 + 1.076018945185327e+03 1.074624978532693e+03 1.073230167248444e+03 1.071834517670182e+03 1.070438036142223e+03 + 1.069040729015589e+03 1.067642602648012e+03 1.066243663403937e+03 1.064843917654515e+03 1.063443371777609e+03 + 1.062042032157791e+03 1.060639905186343e+03 1.059236997261256e+03 1.057833314787232e+03 1.056428864175682e+03 + 1.055023651844726e+03 1.053617684219196e+03 1.052210967730631e+03 1.050803508817282e+03 1.049395313897890e+03 + 1.047986388534756e+03 1.046576737255851e+03 1.045166364529164e+03 1.043755274824231e+03 1.042343472612131e+03 + 1.040930962365484e+03 1.039517748558457e+03 1.038103835666756e+03 1.036689228167636e+03 1.035273930539893e+03 + 1.033857947263865e+03 1.032441282821436e+03 1.031023941696033e+03 1.029605928372625e+03 1.028187247337727e+03 + 1.026767903079397e+03 1.025347900087235e+03 1.023927242852386e+03 1.022505935867538e+03 1.021083983626923e+03 + 1.019661390626317e+03 1.018238161363038e+03 1.016814300335948e+03 1.015389812045455e+03 1.013964700993507e+03 + 1.012538971683598e+03 1.011112628620765e+03 1.009685676311588e+03 1.008258119264191e+03 1.006829961988242e+03 + 1.005401208994952e+03 1.003971864797076e+03 1.002541933908912e+03 1.001111420846301e+03 9.996803301266303e+02 + 9.982486662688275e+02 9.968164337933661e+02 9.953836372222621e+02 9.939502810790750e+02 9.925163698889086e+02 + 9.910819081784098e+02 9.896469004757686e+02 9.882113513107199e+02 9.867752652145410e+02 9.853386467200531e+02 + 9.839015003616214e+02 9.824638306751541e+02 9.810256421981031e+02 9.795869394694643e+02 9.781477270297768e+02 + 9.767080094211232e+02 9.752677911871300e+02 9.738270768729670e+02 9.723858710253478e+02 9.709441781925295e+02 + 9.695020029243127e+02 9.680593497720415e+02 9.666162232886040e+02 9.651726280284314e+02 9.637285685474986e+02 + 9.622840494033246e+02 9.608390751549712e+02 9.593936503630440e+02 9.579477795896925e+02 9.565014673986094e+02 + 9.550547183550314e+02 9.536075370257383e+02 9.521599279790540e+02 9.507118957848456e+02 9.492634450145238e+02 + 9.478145802410424e+02 9.463653060389005e+02 9.449156269841388e+02 9.434655476543426e+02 9.420150726286407e+02 + 9.405642064877048e+02 9.391129538137513e+02 9.376613191905399e+02 9.362093072033728e+02 9.347569224390970e+02 + 9.333041694861028e+02 9.318510529343232e+02 9.303975773752362e+02 9.289437474018629e+02 9.274895676087672e+02 + 9.260350425920570e+02 9.245801769493847e+02 9.231249752799448e+02 9.216694421844763e+02 9.202135822652619e+02 + 9.187574001261273e+02 9.173009003724419e+02 9.158440876111187e+02 9.143869664506148e+02 9.129295415009306e+02 + 9.114718173736089e+02 9.100137986817383e+02 9.085554900399494e+02 9.070968960644165e+02 9.056380213728581e+02 + 9.041788705845360e+02 9.027194483202552e+02 9.012597592023648e+02 8.997998078547574e+02 8.983395989028686e+02 + 8.968791369736786e+02 8.954184266957105e+02 8.939574726990309e+02 8.924962796152502e+02 8.910348520775226e+02 + 8.895731947205452e+02 8.881113121805595e+02 8.866492090953504e+02 8.851868901042455e+02 8.837243598481174e+02 + 8.822616229693809e+02 8.807986841119955e+02 8.793355479214636e+02 8.778722190448314e+02 8.764087021306887e+02 + 8.749450018291686e+02 8.734811227919481e+02 8.720170696722481e+02 8.705528471248323e+02 8.690884598060085e+02 + 8.676239123736278e+02 8.661592094870851e+02 8.646943558073189e+02 8.632293559968109e+02 8.617642147195870e+02 + 8.602989366412162e+02 8.588335264288111e+02 8.573679887510280e+02 8.559023282780669e+02 8.544365496816713e+02 + 8.529706576351281e+02 8.515046568132680e+02 8.500385518924651e+02 8.485723475506371e+02 8.471060484672456e+02 + 8.456396593232956e+02 8.441731848013352e+02 8.427066295854568e+02 8.412399983612960e+02 8.397732958160319e+02 + 8.383065266383875e+02 8.368396955186294e+02 8.353728071485672e+02 8.339058662215547e+02 8.324388774324890e+02 + 8.309718454778108e+02 8.295047750555044e+02 8.280376708650979e+02 8.265705376076626e+02 8.251033799858133e+02 + 8.236362027037090e+02 8.221690104670519e+02 8.207018079830875e+02 8.192345999606056e+02 8.177673911099388e+02 + 8.163001861429635e+02 8.148329897731001e+02 8.133658067153123e+02 8.118986416861073e+02 8.104314994035359e+02 + 8.089643845871925e+02 8.074973019582153e+02 8.060302562392853e+02 8.045632521546285e+02 8.030962944300132e+02 + 8.016293877927517e+02 8.001625369717000e+02 7.986957466972576e+02 7.972290217013673e+02 7.957623667175162e+02 + 7.942957864807344e+02 7.928292857275953e+02 7.913628691962167e+02 7.898965416262595e+02 7.884303077589279e+02 + 7.869641723369706e+02 7.854981401046790e+02 7.840322158078881e+02 7.825664041939773e+02 7.811007100118686e+02 + 7.796351380120283e+02 7.781696929464658e+02 7.767043795687346e+02 7.752392026339312e+02 7.737741668986956e+02 + 7.723092771212124e+02 7.708445380612087e+02 7.693799544799557e+02 7.679155311402681e+02 7.664512728065041e+02 + 7.649871842445651e+02 7.635232702218972e+02 7.620595355074889e+02 7.605959848718730e+02 7.591326230871256e+02 + 7.576694549268664e+02 7.562064851662584e+02 7.547437185820088e+02 7.532811599523681e+02 7.518188140571300e+02 + 7.503566856776325e+02 7.488947795967565e+02 7.474331005989271e+02 7.459716534701122e+02 7.445104429978242e+02 + 7.430494739711182e+02 7.415887511805935e+02 7.401282794183929e+02 7.386680634782024e+02 7.372081081552518e+02 + 7.357484182463149e+02 7.342889985497084e+02 7.328298538652926e+02 7.313709889944722e+02 7.299124087401947e+02 + 7.284541179069513e+02 7.269961213007771e+02 7.255384237292504e+02 7.240810300014931e+02 7.226239449281712e+02 + 7.211671733214938e+02 7.197107199952134e+02 7.182545897646269e+02 7.167987874465738e+02 7.153433178594373e+02 + 7.138881858231457e+02 7.124333961591685e+02 7.109789536905207e+02 7.095248632417597e+02 7.080711296389870e+02 + 7.066177577098478e+02 7.051647522835304e+02 7.037121181907675e+02 7.022598602638342e+02 7.008079833365500e+02 + 6.993564922442782e+02 6.979053918239249e+02 6.964546869139400e+02 6.950043823543177e+02 6.935544829865950e+02 + 6.921049936538523e+02 6.906559192007142e+02 6.892072644733491e+02 6.877590343194680e+02 6.863112335883264e+02 + 6.848638671307228e+02 6.834169397989994e+02 6.819704564470420e+02 6.805244219302806e+02 6.790788411056876e+02 + 6.776337188317796e+02 6.761890599686175e+02 6.747448693778041e+02 6.733011519224871e+02 6.718579124673579e+02 + 6.704151558786504e+02 6.689728870241429e+02 6.675311107731571e+02 6.660898319965579e+02 6.646490555667547e+02 + 6.632087863576994e+02 6.617690292448882e+02 6.603297891053608e+02 6.588910708177000e+02 6.574528792620325e+02 + 6.560152193200289e+02 6.545780958749028e+02 6.531415138114120e+02 6.517054780158572e+02 6.502699933760831e+02 + 6.488350647814780e+02 6.474006971229736e+02 6.459668952930450e+02 6.445336641857116e+02 6.431010086965356e+02 + 6.416689337226230e+02 6.402374441626239e+02 6.388065449167315e+02 6.373762408866819e+02 6.359465369757564e+02 + 6.345174380887786e+02 6.330889491321157e+02 6.316610750136796e+02 6.302338206429247e+02 6.288071909308491e+02 + 6.273811907899951e+02 6.259558251344477e+02 6.245310988798360e+02 6.231070169433332e+02 6.216835842436550e+02 + 6.202608057010611e+02 6.188386862373554e+02 6.174172307758844e+02 6.159964442415383e+02 6.145763315607522e+02 + 6.131568976615030e+02 6.117381474733122e+02 6.103200859272448e+02 6.089027179559087e+02 6.074860484934565e+02 + 6.060700824755835e+02 6.046548248395288e+02 6.032402805240755e+02 6.018264544695495e+02 6.004133516178208e+02 + 5.990009769123031e+02 5.975893352979532e+02 5.961784317212720e+02 5.947682711303036e+02 5.933588584746357e+02 + 5.919501987053994e+02 5.905422967752705e+02 5.891351576384668e+02 5.877287862507508e+02 5.863231875694282e+02 + 5.849183665533477e+02 5.835143281629030e+02 5.821110773600302e+02 5.807086191082091e+02 5.793069583724634e+02 + 5.779061001193606e+02 5.765060493170109e+02 5.751068109350690e+02 5.737083899447330e+02 5.723107913187440e+02 + 5.709140200313871e+02 5.695180810584912e+02 5.681229793774282e+02 5.667287199671144e+02 5.653353078080089e+02 + 5.639427478821145e+02 5.625510451729782e+02 5.611602046656897e+02 5.597702313468828e+02 5.583811302047351e+02 + 5.569929062289672e+02 5.556055644108436e+02 5.542191097431725e+02 5.528335472203050e+02 5.514488818381369e+02 + 5.500651185941068e+02 5.486822624871968e+02 5.473003185179330e+02 5.459192916883851e+02 5.445391870021655e+02 + 5.431600094644319e+02 5.417817640818839e+02 5.404044558627653e+02 5.390280898168637e+02 5.376526709555103e+02 + 5.362782042915790e+02 5.349046948394886e+02 5.335321476152006e+02 5.321605676362202e+02 5.307899599215965e+02 + 5.294203294919217e+02 5.280516813693320e+02 5.266840205775071e+02 5.253173521416702e+02 5.239516810885877e+02 + 5.225870124465707e+02 5.212233512454725e+02 5.198607025166908e+02 5.184990712931668e+02 5.171384626093851e+02 + 5.157788815013741e+02 5.144203330067055e+02 5.130628221644946e+02 5.117063540154008e+02 5.103509336016263e+02 + 5.089965659669175e+02 5.076432561565640e+02 5.062910092173990e+02 5.049398301977998e+02 5.035897241476866e+02 + 5.022406961185235e+02 5.008927511633182e+02 4.995458943366220e+02 4.982001306945292e+02 4.968554652946787e+02 + 4.955119031962524e+02 4.941694494599757e+02 4.928281091481178e+02 4.914878873244913e+02 4.901487890544524e+02 + 4.888108194049014e+02 4.874739834442815e+02 4.861382862425793e+02 4.848037328713260e+02 4.834703284035954e+02 + 4.821380779140055e+02 4.808069864787175e+02 4.794770591754360e+02 4.781483010834104e+02 4.768207172834317e+02 + 4.754943128578365e+02 4.741690928905032e+02 4.728450624668552e+02 4.715222266738587e+02 4.702005906000235e+02 + 4.688801593354034e+02 4.675609379715956e+02 4.662429316017405e+02 4.649261453205227e+02 4.636105842241698e+02 + 4.622962534104534e+02 4.609831579786886e+02 4.596713030297340e+02 4.583606936659914e+02 4.570513349914071e+02 + 4.557432321114703e+02 4.544363901332138e+02 4.531308141652141e+02 4.518265093175915e+02 4.505234807020092e+02 + 4.492217334316751e+02 4.479212726213398e+02 4.466221033872973e+02 4.453242308473862e+02 4.440276601209875e+02 + 4.427323963290266e+02 4.414384445939725e+02 4.401458100398370e+02 4.388544977921764e+02 4.375645129780900e+02 + 4.362758607262207e+02 4.349885461667554e+02 4.337025744314242e+02 4.324179506535007e+02 4.311346799678025e+02 + 4.298527675106906e+02 4.285722184200691e+02 4.272930378353866e+02 4.260152308976346e+02 4.247388027493482e+02 + 4.234637585346064e+02 4.221901033990317e+02 4.209178424897899e+02 4.196469809555908e+02 4.183775239466873e+02 + 4.171094766148764e+02 4.158428441134982e+02 4.145776315974367e+02 4.133138442231195e+02 4.120514871485177e+02 + 4.107905655331455e+02 4.095310845380616e+02 4.082730493258674e+02 4.070164650607085e+02 4.057613369082738e+02 + 4.045076700357962e+02 4.032554696120511e+02 4.020047408073589e+02 4.007554887935824e+02 3.995077187441286e+02 + 3.982614358339480e+02 3.970166452395346e+02 3.957733521389259e+02 3.945315617117033e+02 3.932912791389912e+02 + 3.920525096034583e+02 3.908152582893162e+02 3.895795303823206e+02 3.883453310697706e+02 3.871126655405087e+02 + 3.858815389849212e+02 3.846519565949380e+02 3.834239235640323e+02 3.821974450872211e+02 3.809725263610652e+02 + 3.797491725836686e+02 3.785273889546788e+02 3.773071806752873e+02 3.760885529482291e+02 3.748715109777822e+02 + 3.736560599697692e+02 3.724422051315553e+02 3.712299516720498e+02 3.700193048017055e+02 3.688102697325187e+02 + 3.676028516780295e+02 3.663970558533210e+02 3.651928874750207e+02 3.639903517612993e+02 3.627894539318706e+02 + 3.615901992079928e+02 3.603925928124674e+02 3.591966399696389e+02 3.580023459053963e+02 3.568097158471716e+02 + 3.556187550239405e+02 3.544294686662223e+02 3.532418620060801e+02 3.520559402771199e+02 3.508717087144923e+02 + 3.496891725548904e+02 3.485083370365518e+02 3.473292073992571e+02 3.461517888843309e+02 3.449760867346407e+02 + 3.438021061945983e+02 3.426298525101589e+02 3.414593309288210e+02 3.402905466996269e+02 3.391235050731623e+02 + 3.379582113015570e+02 3.367946706384836e+02 3.356328883391590e+02 3.344728696603431e+02 3.333146198603399e+02 + 3.321581441989965e+02 3.310034479377038e+02 3.298505363393963e+02 3.286994146685523e+02 3.275500881911931e+02 + 3.264025621748842e+02 3.252568418887342e+02 3.241129326033955e+02 3.229708395910641e+02 3.218305681254797e+02 + 3.206921234819250e+02 3.195555109372272e+02 3.184207357697562e+02 3.172878032594259e+02 3.161567186876940e+02 + 3.150274873375612e+02 3.139001144935722e+02 3.127746054418153e+02 3.116509654699221e+02 3.105291998670680e+02 + 3.094093139239718e+02 3.082913129328962e+02 3.071752021876472e+02 3.060609869835743e+02 3.049486726175709e+02 + 3.038382643880739e+02 3.027297675950632e+02 3.016231875400634e+02 3.005185295261418e+02 2.994157988579094e+02 + 2.983150008415209e+02 2.972161407846750e+02 2.961192239966130e+02 2.950242557881208e+02 2.939312414715272e+02 + 2.928401863607048e+02 2.917510957710699e+02 2.906639750195822e+02 2.895788294247451e+02 2.884956643066055e+02 + 2.874144849867538e+02 2.863352967883243e+02 2.852581050359946e+02 2.841829150559857e+02 2.831097321760628e+02 + 2.820385617255341e+02 2.809694090352515e+02 2.799022794376108e+02 2.788371782665511e+02 2.777741108575549e+02 + 2.767130825476488e+02 2.756540986754025e+02 2.745971645809293e+02 2.735422856058867e+02 2.724894670934750e+02 + 2.714387143884384e+02 2.703900328370648e+02 2.693434277871856e+02 2.682989045881756e+02 2.672564685909533e+02 + 2.662161251479810e+02 2.651778796132642e+02 2.641417373423522e+02 2.631077036923379e+02 2.620757840218578e+02 + 2.610459836910915e+02 2.600183080617631e+02 2.589927624971394e+02 2.579693523620314e+02 2.569480830227931e+02 + 2.559289598473227e+02 2.549119882050614e+02 2.538971734669946e+02 2.528845210056507e+02 2.518740361951020e+02 + 2.508657244109642e+02 2.498595910303967e+02 2.488556414321026e+02 2.478538809963281e+02 2.468543151048638e+02 + 2.458569491410431e+02 2.448617884897432e+02 2.438688385373852e+02 2.428781046719333e+02 2.418895922828956e+02 + 2.409033067613238e+02 2.399192534998131e+02 2.389374378925019e+02 2.379578653350729e+02 2.369805412247519e+02 + 2.360054709603084e+02 2.350326599420553e+02 2.340621135718494e+02 2.330938372530911e+02 2.321278363907239e+02 + 2.311641163912353e+02 2.302026826626565e+02 2.292435406145617e+02 2.282866956580692e+02 2.273321532058407e+02 + 2.263799186720815e+02 2.254299974725404e+02 2.244823950245099e+02 2.235371167468261e+02 2.225941680598685e+02 + 2.216535543855603e+02 2.207152811473682e+02 2.197793537703028e+02 2.188457776809178e+02 2.179145583073106e+02 + 2.169857010791227e+02 2.160592114275385e+02 2.151350947852860e+02 2.142133565866376e+02 2.132940022674083e+02 + 2.123770372649571e+02 2.114624670181867e+02 2.105502969675431e+02 2.096405325550162e+02 2.087331792241393e+02 + 2.078282424199890e+02 2.069257275891860e+02 2.060256401798943e+02 2.051279856418216e+02 2.042327694262190e+02 + 2.033399969858813e+02 2.024496737751469e+02 2.015618052498977e+02 2.006763968675590e+02 1.997934540871004e+02 + 1.989129823690343e+02 1.980349871754169e+02 1.971594739698481e+02 1.962864482174713e+02 1.954159153849736e+02 + 1.945478809405854e+02 1.936823503540812e+02 1.928193290967781e+02 1.919588226415381e+02 1.911008364627658e+02 + 1.902453760364096e+02 1.893924468399617e+02 1.885420543524577e+02 1.876942040544768e+02 1.868489014281417e+02 + 1.860061519571189e+02 1.851659611266184e+02 1.843283344233937e+02 1.834932773357418e+02 1.826607953535034e+02 + 1.818308939680629e+02 1.810035786723481e+02 1.801788549608304e+02 1.793567283295249e+02 1.785372042759901e+02 + 1.777202882993282e+02 1.769059859001850e+02 1.760943025807497e+02 1.752852438447554e+02 1.744788151974785e+02 + 1.736750221457390e+02 1.728738701979007e+02 1.720753648638706e+02 1.712795116550998e+02 1.704863160845825e+02 + 1.696957836668566e+02 1.689079199180039e+02 1.681227303556493e+02 1.673402204989617e+02 1.665603958686532e+02 + 1.657832619869799e+02 1.650088243777409e+02 1.642370885662795e+02 1.634680600794823e+02 1.627017444457793e+02 + 1.619381471951445e+02 1.611772738590951e+02 1.604191299706921e+02 1.596637210645399e+02 1.589110526767867e+02 + 1.581611303451241e+02 1.574139596087874e+02 1.566695460085554e+02 1.559278950867503e+02 1.551890123872385e+02 + 1.544529034554292e+02 1.537195738382757e+02 1.529890290842748e+02 1.522612747434666e+02 1.515363163674351e+02 + 1.508141595093076e+02 1.500948097237555e+02 1.493782725669932e+02 1.486645535967789e+02 1.479536583724143e+02 + 1.472455924547449e+02 1.465403614061596e+02 1.458379707905909e+02 1.451384261735148e+02 1.444417331219514e+02 + 1.437478972044633e+02 1.430569239911578e+02 1.423688190536853e+02 1.416835879652396e+02 1.410012363005585e+02 + 1.403217696359229e+02 1.396451935491577e+02 1.389715136196312e+02 1.383007354282553e+02 1.376328645574854e+02 + 1.369679065913208e+02 1.363058671153038e+02 1.356467517165207e+02 1.349905659836014e+02 1.343373155067194e+02 + 1.336870058775913e+02 1.330396426894780e+02 1.323952315371832e+02 1.317537780170550e+02 1.311152877269845e+02 + 1.304797662664065e+02 1.298472192362996e+02 1.292176522391855e+02 1.285910708791301e+02 1.279674807617425e+02 + 1.273468874941753e+02 1.267292966851250e+02 1.261147139448316e+02 1.255031448850783e+02 1.248945951191923e+02 + 1.242890702620443e+02 1.236865759300485e+02 1.230871177411627e+02 1.224907013148884e+02 1.218973322722703e+02 + 1.213070162358971e+02 1.207197588299010e+02 1.201355656799576e+02 1.195544424132864e+02 1.189763946586499e+02 + 1.184014280463548e+02 1.178295482082510e+02 1.172607607777323e+02 1.166950713897357e+02 1.161324856807421e+02 + 1.155730092887757e+02 1.150166478534045e+02 1.144634070157400e+02 1.139132924184372e+02 1.133663097056950e+02 + 1.128224645232555e+02 1.122817625184044e+02 1.117442093399712e+02 1.112098106383290e+02 1.106785720653942e+02 + 1.101504843345202e+02 1.096253193854976e+02 1.091027814759659e+02 1.085828903190926e+02 1.080656662057070e+02 + 1.075510744401853e+02 1.070391017583160e+02 1.065297369211215e+02 1.060229642403793e+02 1.055187689946627e+02 + 1.050171373101604e+02 1.045180558156006e+02 1.040215103049707e+02 1.035274865113781e+02 1.030359706887152e+02 + 1.025469492169604e+02 1.020604083357866e+02 1.015763340040288e+02 1.010947131078929e+02 1.006155327791835e+02 + 1.001387792631148e+02 9.966443911893010e+01 9.919249927205091e+01 9.872294669690289e+01 9.825576811144268e+01 + 9.779095024426459e+01 9.732848086108395e+01 9.686834738339628e+01 9.641053663288847e+01 9.595503591883143e+01 + 9.550183276437639e+01 9.505091470489599e+01 9.460226894357737e+01 9.415588307372171e+01 9.371174549820027e+01 + 9.326984390100915e+01 9.283016578095182e+01 9.239269910989660e+01 9.195743199867270e+01 9.152435246657959e+01 + 9.109344822825337e+01 9.066470776170968e+01 9.023811990175319e+01 8.981367265385576e+01 8.939135422700863e+01 + 8.897115319588202e+01 8.855305819940260e+01 8.813705766268812e+01 8.772313993524557e+01 8.731129428898021e+01 + 8.690150981214184e+01 8.649377498492467e+01 8.608807868460502e+01 8.568441000539183e+01 8.528275807208179e+01 + 8.488311171021131e+01 8.448546000255536e+01 8.408979283578468e+01 8.369609949978657e+01 8.330436902264381e+01 + 8.291459088961614e+01 8.252675470341519e+01 8.214085000107356e+01 8.175686603719873e+01 8.137479266933553e+01 + 8.099462018292702e+01 8.061633811896954e+01 8.023993612969721e+01 7.986540422509246e+01 7.949273245617202e+01 + 7.912191071864751e+01 7.875292880591886e+01 7.838577728963824e+01 7.802044667908689e+01 7.765692688210476e+01 + 7.729520814701189e+01 7.693528093921003e+01 7.657713574044320e+01 7.622076279877933e+01 7.586615250876412e+01 + 7.551329599462582e+01 7.516218394284439e+01 7.481280673973237e+01 7.446515517211270e+01 7.411922012543234e+01 + 7.377499243991551e+01 7.343246273248482e+01 7.309162206375170e+01 7.275246194060588e+01 7.241497325488510e+01 + 7.207914691168762e+01 7.174497413637995e+01 7.141244624067238e+01 7.108155440657860e+01 7.075228964021176e+01 + 7.042464364044737e+01 7.009860816502822e+01 6.977417437950896e+01 6.945133371117183e+01 6.913007780419414e+01 + 6.881039831641085e+01 6.849228672098478e+01 6.817573455985929e+01 6.786073404036127e+01 6.754727706019318e+01 + 6.723535518365489e+01 6.692496029976250e+01 6.661608442214438e+01 6.630871955818391e+01 6.600285747074972e+01 + 6.569849025826812e+01 6.539561050984807e+01 6.509421028016476e+01 6.479428156422156e+01 6.449581665898590e+01 + 6.419880794007263e+01 6.390324769379086e+01 6.360912802573969e+01 6.331644161216560e+01 6.302518126952705e+01 + 6.273533924838438e+01 6.244690800283556e+01 6.215988021335375e+01 6.187424856554645e+01 6.159000558852496e+01 + 6.130714382209544e+01 6.102565642873360e+01 6.074553634647369e+01 6.046677613965124e+01 6.018936867893675e+01 + 5.991330696615304e+01 5.963858400265185e+01 5.936519255461710e+01 5.909312563142009e+01 5.882237675846172e+01 + 5.855293899151076e+01 5.828480526925385e+01 5.801796883717194e+01 5.775242299813667e+01 5.748816098906929e+01 + 5.722517588172157e+01 5.696346118973321e+01 5.670301063052477e+01 5.644381744585571e+01 5.618587497447161e+01 + 5.592917675378749e+01 5.567371639288440e+01 5.541948735564524e+01 5.516648303666721e+01 5.491469740133566e+01 + 5.466412430128952e+01 5.441475721341882e+01 5.416658984866251e+01 5.391961604526729e+01 5.367382965707854e+01 + 5.342922435049869e+01 5.318579394824101e+01 5.294353276046760e+01 5.270243471566913e+01 5.246249358126801e+01 + 5.222370341980431e+01 5.198605834991378e+01 5.174955243603662e+01 5.151417956992881e+01 5.127993401538280e+01 + 5.104681029539683e+01 5.081480246751264e+01 5.058390465007635e+01 5.035411117607305e+01 5.012541641928832e+01 + 4.989781463692880e+01 4.967129999443014e+01 4.944586717469857e+01 4.922151081792142e+01 4.899822516393252e+01 + 4.877600466591702e+01 4.855484391176263e+01 4.833473749525371e+01 4.811567985888949e+01 4.789766553100244e+01 + 4.768068948486052e+01 4.746474643299185e+01 4.724983089968822e+01 4.703593761581940e+01 4.682306140175855e+01 + 4.661119706938157e+01 4.640033923440899e+01 4.619048280117971e+01 4.598162297433280e+01 4.577375454810339e+01 + 4.556687232031752e+01 4.536097129194708e+01 4.515604651624491e+01 4.495209295916556e+01 4.474910546848848e+01 + 4.454707932343867e+01 4.434600983627007e+01 4.414589194663536e+01 4.394672075425581e+01 4.374849149110094e+01 + 4.355119939554362e+01 4.335483958155968e+01 4.315940720272008e+01 4.296489783321342e+01 4.277130684141869e+01 + 4.257862938067940e+01 4.238686082011235e+01 4.219599659307687e+01 4.200603211268383e+01 4.181696265307154e+01 + 4.162878369849639e+01 4.144149102922540e+01 4.125508008000694e+01 4.106954625154178e+01 4.088488514080404e+01 + 4.070109237453877e+01 4.051816351991027e+01 4.033609404369983e+01 4.015487975529847e+01 3.997451654390139e+01 + 3.979499995457292e+01 3.961632565249730e+01 3.943848943565658e+01 3.926148710146721e+01 3.908531435163689e+01 + 3.890996689581685e+01 3.873544082272831e+01 3.856173207783515e+01 3.838883637414560e+01 3.821674961156019e+01 + 3.804546776546066e+01 3.787498680517137e+01 3.770530255859592e+01 3.753641100849845e+01 3.736830845518836e+01 + 3.720099088344971e+01 3.703445420945200e+01 3.686869456603723e+01 3.670370808841574e+01 3.653949085950763e+01 + 3.637603888796111e+01 3.621334844811717e+01 3.605141592615973e+01 3.589023740445852e+01 3.572980904042850e+01 + 3.557012712196481e+01 3.541118795282225e+01 3.525298774403768e+01 3.509552267323749e+01 3.493878928773343e+01 + 3.478278404343990e+01 3.462750313614663e+01 3.447294293878365e+01 3.431909990161546e+01 3.416597046087814e+01 + 3.401355094900445e+01 3.386183779648810e+01 3.371082772101448e+01 3.356051721064496e+01 3.341090265530899e+01 + 3.326198061398263e+01 3.311374767636361e+01 3.296620040125966e+01 3.281933525310492e+01 3.267314891432770e+01 + 3.252763821351709e+01 3.238279969616838e+01 3.223862995512887e+01 3.209512571750849e+01 3.195228370249094e+01 + 3.181010057023420e+01 3.166857295105629e+01 3.152769775432829e+01 3.138747186368265e+01 3.124789194582367e+01 + 3.110895478177638e+01 3.097065722333928e+01 3.083299612203396e+01 3.069596823521478e+01 3.055957038379009e+01 + 3.042379968490992e+01 3.028865305190764e+01 3.015412726448298e+01 3.002021927954454e+01 2.988692608783410e+01 + 2.975424465393443e+01 2.962217185358958e+01 2.949070472525562e+01 2.935984046863818e+01 2.922957605244617e+01 + 2.909990844798608e+01 2.897083474125067e+01 2.884235205411202e+01 2.871445744621140e+01 2.858714789194334e+01 + 2.846042066311678e+01 2.833427304434733e+01 2.820870204788112e+01 2.808370481822039e+01 2.795927858955916e+01 + 2.783542056310479e+01 2.771212788710439e+01 2.758939774558937e+01 2.746722754519704e+01 2.734561457842300e+01 + 2.722455602005491e+01 2.710404915757552e+01 2.698409131619408e+01 2.686467981339180e+01 2.674581188504884e+01 + 2.662748489299116e+01 2.650969637323688e+01 2.639244364869198e+01 2.627572402574995e+01 2.615953493480668e+01 + 2.604387380499337e+01 2.592873803144385e+01 2.581412497154068e+01 2.570003216993883e+01 2.558645721031992e+01 + 2.547339748309297e+01 2.536085044648649e+01 2.524881363723968e+01 2.513728460374055e+01 2.502626081142699e+01 + 2.491573971820056e+01 2.480571905896494e+01 2.469619646153339e+01 2.458716938319504e+01 2.447863542000312e+01 + 2.437059221927192e+01 2.426303741725681e+01 2.415596854366440e+01 2.404938323139217e+01 2.394327933047775e+01 + 2.383765447837906e+01 2.373250626120992e+01 2.362783239922733e+01 2.352363062421024e+01 2.341989863680159e+01 + 2.331663407933185e+01 2.321383475989216e+01 2.311149855755017e+01 2.300962316438995e+01 2.290820631357202e+01 + 2.280724581327735e+01 2.270673948178020e+01 2.260668508940155e+01 2.250708039173678e+01 2.240792334786956e+01 + 2.230921186720802e+01 2.221094371595302e+01 2.211311674173436e+01 2.201572884123411e+01 2.191877792312015e+01 + 2.182226182065280e+01 2.172617842216956e+01 2.163052579410284e+01 2.153530186271772e+01 2.144050449256298e+01 + 2.134613164544727e+01 2.125218130870039e+01 2.115865145244560e+01 2.106553997668644e+01 2.097284492087666e+01 + 2.088056441996010e+01 2.078869643251129e+01 2.069723893213309e+01 2.060618996606658e+01 2.051554761096601e+01 + 2.042530989859754e+01 2.033547481777502e+01 2.024604054022628e+01 2.015700522393599e+01 2.006836688994228e+01 + 1.998012363072147e+01 1.989227358045817e+01 1.980481486918973e+01 1.971774557717947e+01 1.963106382303616e+01 + 1.954476789103884e+01 1.945885594703988e+01 1.937332608222908e+01 1.928817649453870e+01 1.920340539662878e+01 + 1.911901098077130e+01 1.903499138773951e+01 1.895134486255558e+01 1.886806974988112e+01 1.878516424109755e+01 + 1.870262653275597e+01 1.862045489823334e+01 1.853864761644500e+01 1.845720293609644e+01 1.837611907561623e+01 + 1.829539441141390e+01 1.821502731690405e+01 1.813501600648008e+01 1.805535878852776e+01 1.797605402680784e+01 + 1.789710004813803e+01 1.781849513976010e+01 1.774023761822760e+01 1.766232596769640e+01 1.758475857461898e+01 + 1.750753373031707e+01 1.743064982368309e+01 1.735410526816905e+01 1.727789846424588e+01 1.720202775432962e+01 + 1.712649156263800e+01 1.705128842771503e+01 1.697641675133914e+01 1.690187492053174e+01 1.682766139576636e+01 + 1.675377465125957e+01 1.668021313537254e+01 1.660697525047803e+01 1.653405953620346e+01 1.646146456303875e+01 + 1.638918876353225e+01 1.631723061252691e+01 1.624558863577738e+01 1.617426136715184e+01 1.610324729276991e+01 + 1.603254489420701e+01 1.596215281065743e+01 1.589206962268447e+01 1.582229381597797e+01 1.575282394813798e+01 + 1.568365860435203e+01 1.561479636559848e+01 1.554623575841051e+01 1.547797536749664e+01 1.541001389568697e+01 + 1.534234992945672e+01 1.527498202635700e+01 1.520790881496337e+01 1.514112893627654e+01 1.507464101206718e+01 + 1.500844361854594e+01 1.494253544400039e+01 1.487691522461213e+01 1.481158156982783e+01 1.474653311471545e+01 + 1.468176854391490e+01 1.461728655322583e+01 1.455308580005108e+01 1.448916492494823e+01 1.442552270891503e+01 + 1.436215789907635e+01 1.429906914560298e+01 1.423625515786986e+01 1.417371467503432e+01 1.411144643634281e+01 + 1.404944913182382e+01 1.398772148936426e+01 1.392626235467004e+01 1.386507047757601e+01 1.380414456703780e+01 + 1.374348339923097e+01 1.368308576360786e+01 1.362295043539383e+01 1.356307614411792e+01 1.350346171009224e+01 + 1.344410601461897e+01 1.338500782259274e+01 1.332616591200318e+01 1.326757911048049e+01 1.320924625504148e+01 + 1.315116615215319e+01 1.309333758418828e+01 1.303575945915385e+01 1.297843067064863e+01 1.292135001185642e+01 + 1.286451632934388e+01 1.280792850075226e+01 1.275158540067995e+01 1.269548586414703e+01 1.263962874841400e+01 + 1.258401302186647e+01 1.252863758019894e+01 1.247350127006052e+01 1.241860299544399e+01 1.236394167532885e+01 + 1.230951622025856e+01 1.225532549825102e+01 1.220136844757296e+01 1.214764407513537e+01 1.209415128431592e+01 + 1.204088897936275e+01 1.198785611322907e+01 1.193505164847797e+01 1.188247452422181e+01 1.183012365035161e+01 + 1.177799804372636e+01 1.172609672645034e+01 1.167441862559045e+01 1.162296270435431e+01 1.157172795813644e+01 + 1.152071338824009e+01 1.146991795771504e+01 1.141934063624516e+01 1.136898050295155e+01 1.131883658051165e+01 + 1.126890783457083e+01 1.121919328583311e+01 1.116969196974251e+01 1.112040291453270e+01 1.107132511138846e+01 + 1.102245760367597e+01 1.097379950683186e+01 1.092534984778681e+01 1.087710764406476e+01 1.082907196010627e+01 + 1.078124186863284e+01 1.073361642501848e+01 1.068619465441603e+01 1.063897567074718e+01 1.059195860734133e+01 + 1.054514250814830e+01 1.049852644360809e+01 1.045210951602862e+01 1.040589083229813e+01 1.035986946911022e+01 + 1.031404450080543e+01 1.026841510170119e+01 1.022298040707346e+01 1.017773949095798e+01 1.013269147478631e+01 + 1.008783549702620e+01 1.004317069189082e+01 9.998696157456914e+00 9.954411030186206e+00 9.910314523784715e+00 + 9.866405774945729e+00 9.822683900561229e+00 9.779148062474189e+00 9.735797433007823e+00 9.692631171490490e+00 + 9.649648402951970e+00 9.606848328743531e+00 9.564230182014787e+00 9.521793107635142e+00 9.479536270440141e+00 + 9.437458869806633e+00 9.395560106559989e+00 9.353839157926716e+00 9.312295192835592e+00 9.270927467731591e+00 + 9.229735216231479e+00 9.188717610212938e+00 9.147873860369382e+00 9.107203196336844e+00 9.066704846764596e+00 + 9.026378005702853e+00 8.986221892357717e+00 8.946235805206038e+00 8.906418978693665e+00 8.866770619316361e+00 + 8.827289975974383e+00 8.787976307390357e+00 8.748828863538764e+00 8.709846863139358e+00 8.671029583554503e+00 + 8.632376341244221e+00 8.593886376949055e+00 8.555558939921891e+00 8.517393311170933e+00 8.479388776756116e+00 + 8.441544603229096e+00 8.403860042243403e+00 8.366334424744339e+00 8.328967072292842e+00 8.291757243124138e+00 + 8.254704227472720e+00 8.217807335382002e+00 8.181065876905594e+00 8.144479133106664e+00 8.108046399433587e+00 + 8.071767047639053e+00 8.035640397926882e+00 7.999665736506032e+00 7.963842390434660e+00 7.928169696145141e+00 + 7.892646983285742e+00 7.857273552651162e+00 7.822048750599857e+00 7.786971968025827e+00 7.752042529333232e+00 + 7.717259758863888e+00 7.682623011133142e+00 7.648131647347260e+00 7.613785013617140e+00 7.579582436948184e+00 + 7.545523312250220e+00 7.511607037617057e+00 7.477832951167176e+00 7.444200413093294e+00 7.410708803334905e+00 + 7.377357505498556e+00 7.344145878673218e+00 7.311073286547245e+00 7.278139163173499e+00 7.245342906306997e+00 + 7.212683876663248e+00 7.180161467446147e+00 7.147775082852699e+00 7.115524124234772e+00 7.083407965702390e+00 + 7.051426016132217e+00 7.019577732801474e+00 6.987862512275252e+00 6.956279745475502e+00 6.924828855941318e+00 + 6.893509269882150e+00 6.862320401692200e+00 6.831261647888545e+00 6.800332460884749e+00 6.769532305211046e+00 + 6.738860589806862e+00 6.708316738463165e+00 6.677900193977888e+00 6.647610403615440e+00 6.617446795946176e+00 + 6.587408797932629e+00 6.557495898186097e+00 6.527707560796614e+00 6.498043211862364e+00 6.468502306113241e+00 + 6.439084309299234e+00 6.409788685242900e+00 6.380614873655190e+00 6.351562339061567e+00 6.322630595895343e+00 + 6.293819108127046e+00 6.265127326375664e+00 6.236554729526047e+00 6.208100805116588e+00 6.179765032202197e+00 + 6.151546864740690e+00 6.123445807150094e+00 6.095461385258917e+00 6.067593067877628e+00 6.039840335121551e+00 + 6.012202688508743e+00 5.984679633169969e+00 5.957270656961056e+00 5.929975240292937e+00 5.902792923627279e+00 + 5.875723232013562e+00 5.848765648702115e+00 5.821919682493143e+00 5.795184854142510e+00 5.768560683026402e+00 + 5.742046666390822e+00 5.715642318587924e+00 5.689347205919744e+00 5.663160851223163e+00 5.637082758311135e+00 + 5.611112458697719e+00 5.585249491519008e+00 5.559493390584049e+00 5.533843667789125e+00 5.508299872311603e+00 + 5.482861578646651e+00 5.457528314665947e+00 5.432299611523626e+00 5.407175018586152e+00 5.382154093094761e+00 + 5.357236378022760e+00 5.332421403106363e+00 5.307708752059064e+00 5.283098003376689e+00 5.258588694187007e+00 + 5.234180379291222e+00 5.209872626694981e+00 5.185665008050016e+00 5.161557074183171e+00 5.137548383980142e+00 + 5.113638545797982e+00 5.089827134282968e+00 5.066113702430728e+00 5.042497830741953e+00 5.018979105007048e+00 + 4.995557105455633e+00 4.972231392615168e+00 4.949001558388967e+00 4.925867224885915e+00 4.902827967986653e+00 + 4.879883363679411e+00 4.857033008673309e+00 4.834276503129009e+00 4.811613436797770e+00 4.789043387081744e+00 + 4.766565977795326e+00 4.744180833573695e+00 4.721887536130310e+00 4.699685684376157e+00 4.677574891583497e+00 + 4.655554772271826e+00 4.633624922898647e+00 4.611784942911348e+00 4.590034481232405e+00 4.568373160121153e+00 + 4.546800575450856e+00 4.525316347519302e+00 4.503920103923871e+00 4.482611469298424e+00 4.461390048788094e+00 + 4.440255471271009e+00 4.419207398665950e+00 4.398245451269402e+00 4.377369245425554e+00 4.356578419383048e+00 + 4.335872613273037e+00 4.315251459075552e+00 4.294714576337845e+00 4.274261622204341e+00 4.253892261314030e+00 + 4.233606119889290e+00 4.213402835603544e+00 4.193282059746365e+00 4.173243445650493e+00 4.153286631923412e+00 + 4.133411255497697e+00 4.113616998652003e+00 4.093903524786619e+00 4.074270469191258e+00 4.054717490515994e+00 + 4.035244253601178e+00 4.015850419023907e+00 3.996535633568783e+00 3.977299560905666e+00 3.958141896495164e+00 + 3.939062301025637e+00 3.920060427447142e+00 3.901135950094528e+00 3.882288544897898e+00 3.863517881118590e+00 + 3.844823615448907e+00 3.826205437051391e+00 3.807663047653544e+00 3.789196110563124e+00 3.770804297342049e+00 + 3.752487294212357e+00 3.734244789018890e+00 3.716076457976182e+00 3.697981972490954e+00 3.679961043694115e+00 + 3.662013372248035e+00 3.644138631063968e+00 3.626336509775109e+00 3.608606705542072e+00 3.590948914412318e+00 + 3.573362819793663e+00 3.555848115085657e+00 3.538404523614169e+00 3.521031745026515e+00 3.503729467883798e+00 + 3.486497394134707e+00 3.469335231734055e+00 3.452242686325544e+00 3.435219448952052e+00 3.418265234650198e+00 + 3.401379774604279e+00 3.384562769850576e+00 3.367813923930398e+00 3.351132951883403e+00 3.334519571031865e+00 + 3.317973491801103e+00 3.301494419647167e+00 3.285082090084510e+00 3.268736234671993e+00 3.252456560777042e+00 + 3.236242786971220e+00 3.220094639575606e+00 3.204011846234647e+00 3.187994121490988e+00 3.172041185626448e+00 + 3.156152791161071e+00 3.140328668842820e+00 3.124568535295174e+00 3.108872124034968e+00 3.093239171871656e+00 + 3.077669412161458e+00 3.062162565910707e+00 3.046718374098970e+00 3.031336596904380e+00 3.016016966139392e+00 + 3.000759212810465e+00 2.985563079528153e+00 2.970428312130104e+00 2.955354650145179e+00 2.940341825152254e+00 + 2.925389598488303e+00 2.910497731503551e+00 2.895665957526404e+00 2.880894022713473e+00 2.866181682137055e+00 + 2.851528688498591e+00 2.836934785005289e+00 2.822399718118186e+00 2.807923264019232e+00 2.793505182293368e+00 + 2.779145216423770e+00 2.764843124903896e+00 2.750598669795774e+00 2.736411610868753e+00 2.722281698431688e+00 + 2.708208697067331e+00 2.694192390113966e+00 2.680232535961204e+00 2.666328890540199e+00 2.652481222662398e+00 + 2.638689303226956e+00 2.624952898002155e+00 2.611271764144950e+00 2.597645683492627e+00 2.584074442444535e+00 + 2.570557801667266e+00 2.557095530257868e+00 2.543687406599445e+00 2.530333209423413e+00 2.517032707379746e+00 + 2.503785668122807e+00 2.490591889861845e+00 2.477451158950901e+00 2.464363243138197e+00 2.451327922049569e+00 + 2.438344980862380e+00 2.425414204994132e+00 2.412535368413293e+00 2.399708255484590e+00 2.386932671907132e+00 + 2.374208401602455e+00 2.361535223009603e+00 2.348912926727443e+00 2.336341305706971e+00 2.323820149408004e+00 + 2.311349238873846e+00 2.298928374328811e+00 2.286557363678248e+00 2.274235992966902e+00 2.261964052364815e+00 + 2.249741340335214e+00 2.237567658215990e+00 2.225442798573621e+00 2.213366549457367e+00 2.201338726388740e+00 + 2.189359138707274e+00 2.177427577694549e+00 2.165543843493499e+00 2.153707741170415e+00 2.141919076444355e+00 + 2.130177647034976e+00 2.118483256831743e+00 2.106835728234196e+00 2.095234867960482e+00 2.083680476325080e+00 + 2.072172364176171e+00 2.060710343839133e+00 2.049294224696878e+00 2.037923808395575e+00 2.026598913260298e+00 + 2.015319367985618e+00 2.004084979196668e+00 1.992895556108562e+00 1.981750916950703e+00 1.970650881000152e+00 + 1.959595261684839e+00 1.948583868145923e+00 1.937616532016987e+00 1.926693081878526e+00 1.915813328267264e+00 + 1.904977090405082e+00 1.894184192977273e+00 1.883434460875044e+00 1.872727710477953e+00 1.862063762090873e+00 + 1.851442457083682e+00 1.840863622251705e+00 1.830327074965862e+00 1.819832643502570e+00 1.809380158797907e+00 + 1.798969449793061e+00 1.788600336572885e+00 1.778272652771865e+00 1.767986244795942e+00 1.757740938619203e+00 + 1.747536560606076e+00 1.737372946411540e+00 1.727249932639099e+00 1.717167351154095e+00 1.707125028541288e+00 + 1.697122811212298e+00 1.687160545804055e+00 1.677238060829077e+00 1.667355192130723e+00 1.657511781312863e+00 + 1.647707669880958e+00 1.637942692337234e+00 1.628216684763444e+00 1.618529503053863e+00 1.608880992276723e+00 + 1.599270986915247e+00 1.589699330823691e+00 1.580165870897195e+00 1.570670452975510e+00 1.561212914561866e+00 + 1.551793103249197e+00 1.542410880472349e+00 1.533066090216831e+00 1.523758574579748e+00 1.514488184288800e+00 + 1.505254771462676e+00 1.496058184704016e+00 1.486898266759950e+00 1.477774877044576e+00 1.468687878023066e+00 + 1.459637114930725e+00 1.450622438289068e+00 1.441643704572125e+00 1.432700770639202e+00 1.423793487269355e+00 + 1.414921704769478e+00 1.406085292220042e+00 1.397284110913275e+00 1.388518010515092e+00 1.379786849127615e+00 + 1.371090488107240e+00 1.362428788219066e+00 1.353801602746353e+00 1.345208792137069e+00 1.336650231141558e+00 + 1.328125779708811e+00 1.319635294146069e+00 1.311178639017341e+00 1.302755680403749e+00 1.294366281732825e+00 + 1.286010300246468e+00 1.277687607130681e+00 1.269398079017509e+00 1.261141576506052e+00 1.252917963373013e+00 + 1.244727109229262e+00 1.236568884548108e+00 1.228443154841189e+00 1.220349783647821e+00 1.212288651549746e+00 + 1.204259634287000e+00 1.196262595500517e+00 1.188297406122070e+00 1.180363940507803e+00 1.172462072687314e+00 + 1.164591670206239e+00 1.156752605274376e+00 1.148944764287503e+00 1.141168021685895e+00 1.133422246839356e+00 + 1.125707316556084e+00 1.118023109341937e+00 1.110369501923575e+00 1.102746365022667e+00 1.095153580538906e+00 + 1.087591037394418e+00 1.080058609806265e+00 1.072556173728377e+00 1.065083611042832e+00 1.057640804167975e+00 + 1.050227631677888e+00 1.042843969448370e+00 1.035489708218281e+00 1.028164736497249e+00 1.020868930712798e+00 + 1.013602173363602e+00 1.006364350528145e+00 9.991553480860069e-01 9.919750464549014e-01 9.848233287198007e-01 + 9.777000916381701e-01 9.706052224312447e-01 9.635386022157533e-01 9.565001191688937e-01 9.494896630661879e-01 + 9.425071223228538e-01 9.355523797940184e-01 9.286253271866921e-01 9.217258644183214e-01 9.148538781303724e-01 + 9.080092551050607e-01 9.011918879859632e-01 8.944016703005543e-01 8.876384924746002e-01 8.809022413584221e-01 + 8.741928168976413e-01 8.675101190938330e-01 8.608540359442419e-01 8.542244603473701e-01 8.476212889430066e-01 + 8.410444181391276e-01 8.344937399710189e-01 8.279691476350027e-01 8.214705470141707e-01 8.149978368018493e-01 + 8.085509088588196e-01 8.021296614287111e-01 7.957339944800463e-01 7.893638070383275e-01 7.830189931350516e-01 + 7.766994532966268e-01 7.704050967403675e-01 7.641358215802615e-01 7.578915247022724e-01 7.516721083807270e-01 + 7.454774759379389e-01 7.393075284143857e-01 7.331621629407183e-01 7.270412875750237e-01 7.209448123528730e-01 + 7.148726361079928e-01 7.088246610576617e-01 7.028007931997213e-01 6.968009387204053e-01 6.908250000358214e-01 + 6.848728793751606e-01 6.789444908271167e-01 6.730397435251165e-01 6.671585392499849e-01 6.613007849024644e-01 + 6.554663896318030e-01 6.496552624588109e-01 6.438673070778183e-01 6.381024319556428e-01 6.323605552121262e-01 + 6.266415850605696e-01 6.209454272475601e-01 6.152719929073242e-01 6.096211942955035e-01 6.039929419697414e-01 + 5.983871423673978e-01 5.928037109278776e-01 5.872425665727200e-01 5.817036179262789e-01 5.761867757580472e-01 + 5.706919545755328e-01 5.652190691753797e-01 5.597680312855905e-01 5.543387515608681e-01 5.489311514266204e-01 + 5.435451491959484e-01 5.381806555529779e-01 5.328375858091706e-01 5.275158573424954e-01 5.222153871968650e-01 + 5.169360885007255e-01 5.116778775087658e-01 5.064406794925096e-01 5.012244118255510e-01 4.960289886382637e-01 + 4.908543290552675e-01 4.857003532629381e-01 4.805669801867241e-01 4.754541247133137e-01 4.703617092625736e-01 + 4.652896609026711e-01 4.602378967146020e-01 4.552063350475851e-01 4.501948983226124e-01 4.452035092771810e-01 + 4.402320879227842e-01 4.352805523654864e-01 4.303488309750054e-01 4.254368504386150e-01 4.205445290166767e-01 + 4.156717895856258e-01 4.108185573527897e-01 4.059847567861119e-01 4.011703090912549e-01 3.963751374739253e-01 + 3.915991740467544e-01 3.868423443729578e-01 3.821045699452743e-01 3.773857771630841e-01 3.726858934536713e-01 + 3.680048452743795e-01 3.633425553945757e-01 3.586989523890614e-01 3.540739701811214e-01 3.494675340422360e-01 + 3.448795694018267e-01 3.403100055229290e-01 3.357587720701978e-01 3.312257966625470e-01 3.267110046986084e-01 + 3.222143302305144e-01 3.177357072575733e-01 3.132750617821559e-01 3.088323230437107e-01 3.044074228278458e-01 + 3.000002929514869e-01 2.956108619814004e-01 2.912390591663653e-01 2.868848226223222e-01 2.825480855369588e-01 + 2.782287763584979e-01 2.739268276304007e-01 2.696421732978619e-01 2.653747469077652e-01 2.611244782932083e-01 + 2.568913016367161e-01 2.526751570146955e-01 2.484759769388697e-01 2.442936932048949e-01 2.401282413902519e-01 + 2.359795575701045e-01 2.318475761710866e-01 2.277322290127450e-01 2.236334554284879e-01 2.195511960314929e-01 + 2.154853836729677e-01 2.114359536211432e-01 2.074028437636633e-01 2.033859920182897e-01 1.993853337119912e-01 + 1.954008040589642e-01 1.914323463143237e-01 1.874799002688242e-01 1.835434007181165e-01 1.796227861758036e-01 + 1.757179964922509e-01 1.718289711649378e-01 1.679556465242757e-01 1.640979620393169e-01 1.602558632656972e-01 + 1.564292893436780e-01 1.526181778855338e-01 1.488224700413446e-01 1.450421075715582e-01 1.412770310767497e-01 + 1.375271785489454e-01 1.337924939887067e-01 1.300729236356154e-01 1.263684067750867e-01 1.226788841702678e-01 + 1.190042991249222e-01 1.153445951805052e-01 1.116997137432381e-01 1.080695954417651e-01 1.044541881911586e-01 + 1.008534377603918e-01 9.726728475975084e-02 9.369567294988820e-02 9.013854752144720e-02 8.659585347215112e-02 + 8.306753302147955e-02 7.955353046975124e-02 7.605379621791922e-02 7.256827534889604e-02 6.909691079142652e-02 + 6.563964883225221e-02 6.219643640409570e-02 5.876721959493493e-02 5.535194193553600e-02 5.195055179453398e-02 + 4.856300050562060e-02 4.518923308325209e-02 4.182919528191363e-02 3.848283536820589e-02 3.515010193539807e-02 + 3.183094185890936e-02 2.852530077920949e-02 2.523313079087341e-02 2.195438300307553e-02 1.868900335629075e-02 + 1.543694036357313e-02 1.219814405293583e-02 8.972564385828061e-03 5.760148923624660e-03 2.560846417529306e-03 + -6.253884489496408e-04 -3.798605206001689e-03 -6.958856024607482e-03 -1.010619000899848e-02 -1.324065554473652e-02 + -1.636230159824732e-02 -1.947117958312726e-02 -2.256733711284757e-02 -2.565081832749929e-02 -2.872167302619957e-02 + -3.177995089902724e-02 -3.482569914268617e-02 -3.785896464500105e-02 -4.087979562235380e-02 -4.388824175488684e-02 + -4.688434717766576e-02 -4.986815604286890e-02 -5.283971753775529e-02 -5.579907881824794e-02 -5.874628546589089e-02 + -6.168138307363240e-02 -6.460441923558070e-02 -6.751544105442296e-02 -7.041449003639784e-02 -7.330161087707579e-02 + -7.617685125406765e-02 -7.904025608548425e-02 -8.189186951723537e-02 -8.473173608907363e-02 -8.755990257827875e-02 + -9.037641289395969e-02 -9.318130717201861e-02 -9.597463047763352e-02 -9.875642835115833e-02 -1.015267439140877e-01 + -1.042856199263307e-01 -1.070331001684683e-01 -1.097692300567918e-01 -1.124940502948268e-01 -1.152076007898061e-01 + -1.179099262631479e-01 -1.206010699593113e-01 -1.232810735016665e-01 -1.259499784255051e-01 -1.286078279418341e-01 + -1.312546653333709e-01 -1.338905286984875e-01 -1.365154583874092e-01 -1.391294979538990e-01 -1.417326885345280e-01 + -1.443250704192513e-01 -1.469066841433861e-01 -1.494775722507627e-01 -1.520377752494497e-01 -1.545873297590701e-01 + -1.571262765202916e-01 -1.596546572452540e-01 -1.621725113907878e-01 -1.646798779801165e-01 -1.671767967821347e-01 + -1.696633092874520e-01 -1.721394530811854e-01 -1.746052643091513e-01 -1.770607836101869e-01 -1.795060506428017e-01 + -1.819411034225526e-01 -1.843659798390828e-01 -1.867807191554161e-01 -1.891853611111403e-01 -1.915799407499077e-01 + -1.939644945120454e-01 -1.963390621459183e-01 -1.987036813730624e-01 -2.010583889984393e-01 -2.034032219467188e-01 + -2.057382189127211e-01 -2.080634172465200e-01 -2.103788504106409e-01 -2.126845552585028e-01 -2.149805700057577e-01 + -2.172669307458855e-01 -2.195436731393316e-01 -2.218108333786645e-01 -2.240684493062661e-01 -2.263165556286022e-01 + -2.285551851690127e-01 -2.307843748874083e-01 -2.330041611277884e-01 -2.352145785311434e-01 -2.374156618282909e-01 + -2.396074467707450e-01 -2.417899696732801e-01 -2.439632627554057e-01 -2.461273590292558e-01 -2.482822949571798e-01 + -2.504281050002428e-01 -2.525648226666662e-01 -2.546924818382261e-01 -2.568111176810049e-01 -2.589207645010757e-01 + -2.610214530059819e-01 -2.631132165202481e-01 -2.651960899948890e-01 -2.672701065219724e-01 -2.693352987894519e-01 + -2.713916998229662e-01 -2.734393439668777e-01 -2.754782632038173e-01 -2.775084874639143e-01 -2.795300503441993e-01 + -2.815429852855671e-01 -2.835473240274155e-01 -2.855430981234691e-01 -2.875303400246380e-01 -2.895090831627840e-01 + -2.914793573631382e-01 -2.934411924374482e-01 -2.953946213942734e-01 -2.973396760049649e-01 -2.992763870705049e-01 + -3.012047853752455e-01 -3.031249029054077e-01 -3.050367713048046e-01 -3.069404187491607e-01 -3.088358754333808e-01 + -3.107231733999588e-01 -3.126023429151826e-01 -3.144734138246973e-01 -3.163364162512183e-01 -3.181913814969073e-01 + -3.200383391593082e-01 -3.218773166629695e-01 -3.237083442965246e-01 -3.255314526206347e-01 -3.273466708133588e-01 + -3.291540279174764e-01 -3.309535535062730e-01 -3.327452779044484e-01 -3.345292286746930e-01 -3.363054329977739e-01 + -3.380739209920870e-01 -3.398347217688169e-01 -3.415878634526212e-01 -3.433333743100879e-01 -3.450712833788954e-01 + -3.468016195958206e-01 -3.485244091566739e-01 -3.502396793974815e-01 -3.519474593420066e-01 -3.536477770380763e-01 + -3.553406598299846e-01 -3.570261348354672e-01 -3.587042307855341e-01 -3.603749751839582e-01 -3.620383929731605e-01 + -3.636945116923384e-01 -3.653433594409278e-01 -3.669849628231984e-01 -3.686193482790397e-01 -3.702465427747400e-01 + -3.718665743211436e-01 -3.734794684043725e-01 -3.750852495624684e-01 -3.766839451194457e-01 -3.782755819189342e-01 + -3.798601858648072e-01 -3.814377826321034e-01 -3.830083986549013e-01 -3.845720606417443e-01 -3.861287926090124e-01 + -3.876786193539286e-01 -3.892215675502101e-01 -3.907576628594260e-01 -3.922869303026715e-01 -3.938093947284727e-01 + -3.953250822556230e-01 -3.968340182497304e-01 -3.983362256494206e-01 -3.998317293097848e-01 -4.013205549386248e-01 + -4.028027272117153e-01 -4.042782703087232e-01 -4.057472086115670e-01 -4.072095677082399e-01 -4.086653712889545e-01 + -4.101146418277140e-01 -4.115574040934622e-01 -4.129936826934361e-01 -4.144235014035024e-01 -4.158468836578273e-01 + -4.172638535617268e-01 -4.186744357650895e-01 -4.200786523524958e-01 -4.214765258006608e-01 -4.228680805923657e-01 + -4.242533401481378e-01 -4.256323273241845e-01 -4.270050650780072e-01 -4.283715771591216e-01 -4.297318868367957e-01 + -4.310860152683936e-01 -4.324339850671611e-01 -4.337758197699306e-01 -4.351115419219263e-01 -4.364411736856622e-01 + -4.377647373653272e-01 -4.390822563519974e-01 -4.403937525793140e-01 -4.416992465950099e-01 -4.429987609092939e-01 + -4.442923180804305e-01 -4.455799398898891e-01 -4.468616477876415e-01 -4.481374637930542e-01 -4.494074106490894e-01 + -4.506715085877422e-01 -4.519297779021105e-01 -4.531822412097039e-01 -4.544289201442401e-01 -4.556698355752103e-01 + -4.569050083194456e-01 -4.581344599890250e-01 -4.593582121055255e-01 -4.605762842891920e-01 -4.617886970897419e-01 + -4.629954719556403e-01 -4.641966295426422e-01 -4.653921902577345e-01 -4.665821746143150e-01 -4.677666038635413e-01 + -4.689454981292748e-01 -4.701188761476531e-01 -4.712867586709557e-01 -4.724491664926360e-01 -4.736061192593240e-01 + -4.747576368456714e-01 -4.759037394682022e-01 -4.770444475543998e-01 -4.781797800875144e-01 -4.793097558338887e-01 + -4.804343950164401e-01 -4.815537175042383e-01 -4.826677426390972e-01 -4.837764894228364e-01 -4.848799775883490e-01 + -4.859782270303963e-01 -4.870712557287352e-01 -4.881590823344398e-01 -4.892417265305033e-01 -4.903192072931410e-01 + -4.913915433426016e-01 -4.924587534540600e-01 -4.935208569593936e-01 -4.945778724869024e-01 -4.956298174121960e-01 + -4.966767104426105e-01 -4.977185705977166e-01 -4.987554161795947e-01 -4.997872652579317e-01 -5.008141361357437e-01 + -5.018360477540788e-01 -5.028530175622089e-01 -5.038650625463708e-01 -5.048722015765362e-01 -5.058744527800632e-01 + -5.068718334710337e-01 -5.078643614554021e-01 -5.088520548881869e-01 -5.098349318298798e-01 -5.108130088001350e-01 + -5.117863028619736e-01 -5.127548322161382e-01 -5.137186142245088e-01 -5.146776659499980e-01 -5.156320045833772e-01 + -5.165816478015819e-01 -5.175266128170244e-01 -5.184669156304091e-01 -5.194025733016244e-01 -5.203336032597101e-01 + -5.212600221732120e-01 -5.221818466804444e-01 -5.230990936596679e-01 -5.240117804553392e-01 -5.249199232262068e-01 + -5.258235374392936e-01 -5.267226400387954e-01 -5.276172478389746e-01 -5.285073771019844e-01 -5.293930438910602e-01 + -5.302742646986305e-01 -5.311510563423283e-01 -5.320234339437281e-01 -5.328914129379527e-01 -5.337550101355577e-01 + -5.346142414983102e-01 -5.354691226448078e-01 -5.363196694209366e-01 -5.371658979374595e-01 -5.380078240078261e-01 + -5.388454624615836e-01 -5.396788287704753e-01 -5.405079388378121e-01 -5.413328081929075e-01 -5.421534521210617e-01 + -5.429698859177164e-01 -5.437821254261226e-01 -5.445901856060492e-01 -5.453940806517681e-01 -5.461938261275164e-01 + -5.469894375147514e-01 -5.477809296410460e-01 -5.485683172596564e-01 -5.493516154047422e-01 -5.501308394233321e-01 + -5.509060035978606e-01 -5.516771220917993e-01 -5.524442098036262e-01 -5.532072816062331e-01 -5.539663521228516e-01 + -5.547214355736525e-01 -5.554725467511782e-01 -5.562197004144761e-01 -5.569629099559865e-01 -5.577021895124128e-01 + -5.584375539231472e-01 -5.591690174427206e-01 -5.598965939391384e-01 -5.606202972403660e-01 -5.613401421520022e-01 + -5.620561426054913e-01 -5.627683113219669e-01 -5.634766626491997e-01 -5.641812109417922e-01 -5.648819696019924e-01 + -5.655789522526887e-01 -5.662721727674018e-01 -5.669616451334641e-01 -5.676473824290281e-01 -5.683293976251365e-01 + -5.690077046537543e-01 -5.696823171027902e-01 -5.703532481968968e-01 -5.710205111045815e-01 -5.716841193018837e-01 + -5.723440862989044e-01 -5.730004247377283e-01 -5.736531475408438e-01 -5.743022680808630e-01 -5.749477994635019e-01 + -5.755897545119250e-01 -5.762281459317424e-01 -5.768629872133108e-01 -5.774942912813225e-01 -5.781220698864685e-01 + -5.787463360372200e-01 -5.793671029370097e-01 -5.799843829591812e-01 -5.805981885004621e-01 -5.812085322229668e-01 + -5.818154271777390e-01 -5.824188854500640e-01 -5.830189187855023e-01 -5.836155400127914e-01 -5.842087616519486e-01 + -5.847985957903102e-01 -5.853850545399070e-01 -5.859681502822114e-01 -5.865478954643482e-01 -5.871243015837295e-01 + -5.876973804424807e-01 -5.882671445115567e-01 -5.888336058093040e-01 -5.893967761301214e-01 -5.899566672475657e-01 + -5.905132912554449e-01 -5.910666600004119e-01 -5.916167846344484e-01 -5.921636769312483e-01 -5.927073488739303e-01 + -5.932478119884005e-01 -5.937850777230974e-01 -5.943191576345895e-01 -5.948500635775013e-01 -5.953778067525587e-01 + -5.959023980172641e-01 -5.964238491804477e-01 -5.969421717317064e-01 -5.974573766302176e-01 -5.979694750153504e-01 + -5.984784782975928e-01 -5.989843980133127e-01 -5.994872448737363e-01 -5.999870296226286e-01 -6.004837635008013e-01 + -6.009774575116591e-01 -6.014681225640990e-01 -6.019557696406324e-01 -6.024404098188824e-01 -6.029220539582525e-01 + -6.034007123251734e-01 -6.038763957092128e-01 -6.043491151546724e-01 -6.048188811990667e-01 -6.052857043294740e-01 + -6.057495951725935e-01 -6.062105647034982e-01 -6.066686232996821e-01 -6.071237808282512e-01 -6.075760480581535e-01 + -6.080254356249652e-01 -6.084719536597242e-01 -6.089156123708600e-01 -6.093564221655233e-01 -6.097943936088406e-01 + -6.102295366277345e-01 -6.106618611466814e-01 -6.110913776082281e-01 -6.115180960018122e-01 -6.119420262061138e-01 + -6.123631785057825e-01 -6.127815629923925e-01 -6.131971895415724e-01 -6.136100679122567e-01 -6.140202079254689e-01 + -6.144276194632986e-01 -6.148323123693087e-01 -6.152342964516117e-01 -6.156335814880438e-01 -6.160301772367670e-01 + -6.164240932773791e-01 -6.168153390131846e-01 -6.172039241057757e-01 -6.175898582479540e-01 -6.179731510100582e-01 + -6.183538118537011e-01 -6.187318502245757e-01 -6.191072755983122e-01 -6.194800972241303e-01 -6.198503243163954e-01 + -6.202179663089392e-01 -6.205830326036273e-01 -6.209455324825972e-01 -6.213054750121583e-01 -6.216628693834372e-01 + -6.220177248671027e-01 -6.223700505100402e-01 -6.227198553511943e-01 -6.230671484590707e-01 -6.234119388224310e-01 + -6.237542354039819e-01 -6.240940471906395e-01 -6.244313833278470e-01 -6.247662526956897e-01 -6.250986637315333e-01 + -6.254286253149073e-01 -6.257561464374979e-01 -6.260812358699522e-01 -6.264039022632663e-01 -6.267241542804416e-01 + -6.270420007239386e-01 -6.273574502418447e-01 -6.276705113436000e-01 -6.279811924920996e-01 -6.282895022600340e-01 + -6.285954492669960e-01 -6.288990419377586e-01 -6.292002887596219e-01 -6.294991982474318e-01 -6.297957785295903e-01 + -6.300900379535952e-01 -6.303819851813233e-01 -6.306716282540937e-01 -6.309589752809680e-01 -6.312440348023121e-01 + -6.315268150763020e-01 -6.318073241903770e-01 -6.320855701836068e-01 -6.323615610879741e-01 -6.326353050044859e-01 + -6.329068101802829e-01 -6.331760846635813e-01 -6.334431363818833e-01 -6.337079733473078e-01 -6.339706034520735e-01 + -6.342310345121693e-01 -6.344892744839461e-01 -6.347453312805855e-01 -6.349992127114430e-01 -6.352509264768633e-01 + -6.355004804526597e-01 -6.357478826585540e-01 -6.359931404400122e-01 -6.362362612918424e-01 -6.364772532644518e-01 + -6.367161239398067e-01 -6.369528807876881e-01 -6.371875315012039e-01 -6.374200836672138e-01 -6.376505447719858e-01 + -6.378789222449943e-01 -6.381052236017390e-01 -6.383294563385360e-01 -6.385516277126226e-01 -6.387717451483415e-01 + -6.389898161925324e-01 -6.392058481779943e-01 -6.394198483013303e-01 -6.396318237129481e-01 -6.398417817583982e-01 + -6.400497298004382e-01 -6.402556751053731e-01 -6.404596246811356e-01 -6.406615856182318e-01 -6.408615652398488e-01 + -6.410595705960431e-01 -6.412556087124355e-01 -6.414496867908267e-01 -6.416418117430738e-01 -6.418319904244396e-01 + -6.420202299552208e-01 -6.422065373268501e-01 -6.423909194238488e-01 -6.425733831564441e-01 -6.427539354568388e-01 + -6.429325832107947e-01 -6.431093330874931e-01 -6.432841919278923e-01 -6.434571667152847e-01 -6.436282640341581e-01 + -6.437974905134223e-01 -6.439648529819666e-01 -6.441303582355420e-01 -6.442940129046214e-01 -6.444558234243410e-01 + -6.446157964842297e-01 -6.447739387669796e-01 -6.449302567289288e-01 -6.450847570451982e-01 -6.452374463418470e-01 + -6.453883308317777e-01 -6.455374170518916e-01 -6.456847116523639e-01 -6.458302208459006e-01 -6.459739509825424e-01 + -6.461159085765001e-01 -6.462561000624228e-01 -6.463945317857885e-01 -6.465312099893501e-01 -6.466661407794220e-01 + -6.467993305071421e-01 -6.469307857586633e-01 -6.470605124176557e-01 -6.471885165505020e-01 -6.473148048129491e-01 + -6.474393831451855e-01 -6.475622574433044e-01 -6.476834341411803e-01 -6.478029193005811e-01 -6.479207188186653e-01 + -6.480368387749067e-01 -6.481512852365653e-01 -6.482640642356557e-01 -6.483751817763184e-01 -6.484846438333333e-01 + -6.485924563559199e-01 -6.486986252696630e-01 -6.488031563964390e-01 -6.489060555062011e-01 -6.490073285956434e-01 + -6.491069816182633e-01 -6.492050203757027e-01 -6.493014505946639e-01 -6.493962779796888e-01 -6.494895082497514e-01 + -6.495811472172135e-01 -6.496712006463234e-01 -6.497596741452655e-01 -6.498465734697708e-01 -6.499319043537729e-01 + -6.500156722751166e-01 -6.500978828758883e-01 -6.501785418212779e-01 -6.502576544563589e-01 -6.503352264336196e-01 + -6.504112635780723e-01 -6.504857712206107e-01 -6.505587548117625e-01 -6.506302199692129e-01 -6.507001719669850e-01 + -6.507686161481057e-01 -6.508355580770583e-01 -6.509010033515999e-01 -6.509649573333303e-01 -6.510274250599254e-01 + -6.510884119408136e-01 -6.511479234691252e-01 -6.512059649357221e-01 -6.512625414820176e-01 -6.513176583196066e-01 + -6.513713209657690e-01 -6.514235346566493e-01 -6.514743044494572e-01 -6.515236355351222e-01 -6.515715331668240e-01 + -6.516180025498758e-01 -6.516630486086969e-01 -6.517066764698182e-01 -6.517488914696901e-01 -6.517896986474616e-01 + -6.518291029696229e-01 -6.518671094474887e-01 -6.519037232298822e-01 -6.519389493677847e-01 -6.519727927034696e-01 + -6.520052582102593e-01 -6.520363509344871e-01 -6.520660759114448e-01 -6.520944379877177e-01 -6.521214419863292e-01 + -6.521470929034477e-01 -6.521713955379932e-01 -6.521943546611896e-01 -6.522159753870301e-01 -6.522362625000242e-01 + -6.522552205660485e-01 -6.522728545508729e-01 -6.522891692872490e-01 -6.523041693781095e-01 -6.523178594474156e-01 + -6.523302443147758e-01 -6.523413289626511e-01 -6.523511179648659e-01 -6.523596158248584e-01 -6.523668271884714e-01 + -6.523727568212391e-01 -6.523774093997819e-01 -6.523807893579161e-01 -6.523829012952149e-01 -6.523837498990516e-01 + -6.523833397960367e-01 -6.523816754611410e-01 -6.523787613199525e-01 -6.523746019358498e-01 -6.523692018302728e-01 + -6.523625654555820e-01 -6.523546972248629e-01 -6.523456017173497e-01 -6.523352835702680e-01 -6.523237468711672e-01 + -6.523109959032295e-01 -6.522970353197415e-01 -6.522818693382445e-01 -6.522655022842732e-01 -6.522479388337681e-01 + -6.522291831409690e-01 -6.522092393163972e-01 -6.521881118419591e-01 -6.521658050464721e-01 -6.521423231008568e-01 + -6.521176700882644e-01 -6.520918504277817e-01 -6.520648685798258e-01 -6.520367284462982e-01 -6.520074341903623e-01 + -6.519769901852531e-01 -6.519454004576026e-01 -6.519126690272374e-01 -6.518788000417296e-01 -6.518437978790763e-01 + -6.518076667685843e-01 -6.517704106505043e-01 -6.517320333460206e-01 -6.516925389358605e-01 -6.516519318553129e-01 + -6.516102158220000e-01 -6.515673946405215e-01 -6.515234728464969e-01 -6.514784543315630e-01 -6.514323427842886e-01 + -6.513851423523833e-01 -6.513368570527661e-01 -6.512874907235414e-01 -6.512370470939771e-01 -6.511855301990920e-01 + -6.511329442190841e-01 -6.510792928715797e-01 -6.510245798816351e-01 -6.509688091361985e-01 -6.509119847142907e-01 + -6.508541103488035e-01 -6.507951894034477e-01 -6.507352259931611e-01 -6.506742241942834e-01 -6.506121876059120e-01 + -6.505491199228429e-01 -6.504850249436106e-01 -6.504199065016956e-01 -6.503537680222150e-01 -6.502866130342899e-01 + -6.502184457971011e-01 -6.501492700279957e-01 -6.500790890906794e-01 -6.500079066129352e-01 -6.499357263329657e-01 + -6.498625519683058e-01 -6.497883869826074e-01 -6.497132350047277e-01 -6.496370998048885e-01 -6.495599847614121e-01 + -6.494818934475555e-01 -6.494028297363450e-01 -6.493227969968260e-01 -6.492417985197620e-01 -6.491598378013752e-01 + -6.490769185970405e-01 -6.489930446200032e-01 -6.489082192796405e-01 -6.488224457999440e-01 -6.487357275334984e-01 + -6.486480682838258e-01 -6.485594713376021e-01 -6.484699398068251e-01 -6.483794774339799e-01 -6.482880877536140e-01 + -6.481957740532812e-01 -6.481025397024727e-01 -6.480083880017639e-01 -6.479133221889776e-01 -6.478173456351086e-01 + -6.477204618036257e-01 -6.476226741599570e-01 -6.475239858039916e-01 -6.474243999826228e-01 -6.473239202990485e-01 + -6.472225498463482e-01 -6.471202916312221e-01 -6.470171489638400e-01 -6.469131252405815e-01 -6.468082238277443e-01 + -6.467024479420175e-01 -6.465958006550642e-01 -6.464882850509053e-01 -6.463799044773618e-01 -6.462706620382276e-01 + -6.461605607272912e-01 -6.460496040101232e-01 -6.459377950690467e-01 -6.458251367734501e-01 -6.457116323868038e-01 + -6.455972850655802e-01 -6.454820977029684e-01 -6.453660732942879e-01 -6.452492150754419e-01 -6.451315264887545e-01 + -6.450130102914885e-01 -6.448936692680686e-01 -6.447735068128447e-01 -6.446525260129213e-01 -6.445307296530088e-01 + -6.444081203587793e-01 -6.442847014715996e-01 -6.441604765089356e-01 -6.440354480546840e-01 -6.439096188724848e-01 + -6.437829920095609e-01 -6.436555704731397e-01 -6.435273570693492e-01 -6.433983545533010e-01 -6.432685663163126e-01 + -6.431379953365300e-01 -6.430066439769492e-01 -6.428745153347271e-01 -6.427416124750638e-01 -6.426079380140648e-01 + -6.424734947555180e-01 -6.423382856273998e-01 -6.422023135830728e-01 -6.420655814260000e-01 -6.419280919255173e-01 + -6.417898479598759e-01 -6.416508523135933e-01 -6.415111076305331e-01 -6.413706163966455e-01 -6.412293816393564e-01 + -6.410874066048897e-01 -6.409446936267265e-01 -6.408012453136449e-01 -6.406570646910840e-01 -6.405121544270317e-01 + -6.403665170374713e-01 -6.402201550644944e-01 -6.400730715072882e-01 -6.399252691822962e-01 -6.397767504407681e-01 + -6.396275180930010e-01 -6.394775749890055e-01 -6.393269236107165e-01 -6.391755662191552e-01 -6.390235053902433e-01 + -6.388707445708105e-01 -6.387172861694177e-01 -6.385631322023312e-01 -6.384082857966726e-01 -6.382527494896121e-01 + -6.380965253642142e-01 -6.379396162401521e-01 -6.377820248167250e-01 -6.376237535602883e-01 -6.374648052204416e-01 + -6.373051823107587e-01 -6.371448870124290e-01 -6.369839218821269e-01 -6.368222895078627e-01 -6.366599923302766e-01 + -6.364970329561520e-01 -6.363334139746031e-01 -6.361691377885151e-01 -6.360042067688202e-01 -6.358386233547334e-01 + -6.356723901317635e-01 -6.355055093799952e-01 -6.353379833438523e-01 -6.351698147827204e-01 -6.350010061497325e-01 + -6.348315596278746e-01 -6.346614776297652e-01 -6.344907627044540e-01 -6.343194173354602e-01 -6.341474433478579e-01 + -6.339748431233465e-01 -6.338016197812808e-01 -6.336277753787244e-01 -6.334533118997744e-01 -6.332782318265875e-01 + -6.331025376588558e-01 -6.329262316544187e-01 -6.327493157114107e-01 -6.325717923863455e-01 -6.323936643403999e-01 + -6.322149336030685e-01 -6.320356024195775e-01 -6.318556731749607e-01 -6.316751480498738e-01 -6.314940290711796e-01 + -6.313123183267710e-01 -6.311300184615836e-01 -6.309471319109403e-01 -6.307636607640942e-01 -6.305796070902886e-01 + -6.303949730482692e-01 -6.302097608691579e-01 -6.300239725606558e-01 -6.298376103756032e-01 -6.296506769748604e-01 + -6.294631743864889e-01 -6.292751044804592e-01 -6.290864694027335e-01 -6.288972714311484e-01 -6.287075127245377e-01 + -6.285171950849623e-01 -6.283263208775478e-01 -6.281348926187029e-01 -6.279429120773061e-01 -6.277503812180564e-01 + -6.275573022752827e-01 -6.273636774541002e-01 -6.271695087389834e-01 -6.269747979757735e-01 -6.267795473573458e-01 + -6.265837591630624e-01 -6.263874355834504e-01 -6.261905784094625e-01 -6.259931895045528e-01 -6.257952710369122e-01 + -6.255968250363517e-01 -6.253978534898084e-01 -6.251983584520242e-01 -6.249983420853732e-01 -6.247978064572296e-01 + -6.245967533125147e-01 -6.243951846742302e-01 -6.241931026018996e-01 -6.239905086686763e-01 -6.237874050561640e-01 + -6.235837942608177e-01 -6.233796778475696e-01 -6.231750576026635e-01 -6.229699356978790e-01 -6.227643140512986e-01 + -6.225581944126894e-01 -6.223515785171654e-01 -6.221444686516174e-01 -6.219368669106876e-01 -6.217287748516653e-01 + -6.215201944179222e-01 -6.213111276341791e-01 -6.211015763012264e-01 -6.208915420627059e-01 -6.206810267189914e-01 + -6.204700325606027e-01 -6.202585614407183e-01 -6.200466150025669e-01 -6.198341952555039e-01 -6.196213039807257e-01 + -6.194079427661365e-01 -6.191941133919308e-01 -6.189798178811384e-01 -6.187650583625046e-01 -6.185498365366234e-01 + -6.183341539791172e-01 -6.181180123373080e-01 -6.179014136693182e-01 -6.176843597571294e-01 -6.174668518753883e-01 + -6.172488922358068e-01 -6.170304830078728e-01 -6.168116255085183e-01 -6.165923213940302e-01 -6.163725725542526e-01 + -6.161523808379610e-01 -6.159317477445455e-01 -6.157106747923912e-01 -6.154891641891720e-01 -6.152672177134336e-01 + -6.150448367622374e-01 -6.148220230127394e-01 -6.145987783325538e-01 -6.143751045698781e-01 -6.141510029326600e-01 + -6.139264750393221e-01 -6.137015231470567e-01 -6.134761489851926e-01 -6.132503540152313e-01 -6.130241396532106e-01 + -6.127975076851865e-01 -6.125704598048077e-01 -6.123429972989166e-01 -6.121151221351967e-01 -6.118868363314907e-01 + -6.116581411278224e-01 -6.114290380220153e-01 -6.111995287783158e-01 -6.109696151823703e-01 -6.107392985450728e-01 + -6.105085801024925e-01 -6.102774622058419e-01 -6.100459465922933e-01 -6.098140342484372e-01 -6.095817267256873e-01 + -6.093490257933440e-01 -6.091159331809802e-01 -6.088824500709522e-01 -6.086485779905337e-01 -6.084143191489354e-01 + -6.081796748129595e-01 -6.079446461968719e-01 -6.077092351925356e-01 -6.074734432434898e-01 -6.072372716150822e-01 + -6.070007218360295e-01 -6.067637956065657e-01 -6.065264946232775e-01 -6.062888203126375e-01 -6.060507740692458e-01 + -6.058123573561740e-01 -6.055735718185850e-01 -6.053344188005130e-01 -6.050948994718379e-01 -6.048550157592759e-01 + -6.046147693250087e-01 -6.043741612917217e-01 -6.041331930896253e-01 -6.038918662688606e-01 -6.036501823335466e-01 + -6.034081424814672e-01 -6.031657481058161e-01 -6.029230011393863e-01 -6.026799028730719e-01 -6.024364544399844e-01 + -6.021926574869638e-01 -6.019485136055120e-01 -6.017040241022006e-01 -6.014591897708976e-01 -6.012140122415236e-01 + -6.009684936432825e-01 -6.007226351565053e-01 -6.004764378633045e-01 -6.002299030368295e-01 -5.999830322604393e-01 + -5.997358269112610e-01 -5.994882881008079e-01 -5.992404174674395e-01 -5.989922165630734e-01 -5.987436865327392e-01 + -5.984948286273432e-01 -5.982456442781595e-01 -5.979961350600861e-01 -5.977463018616249e-01 -5.974961457245347e-01 + -5.972456688462123e-01 -5.969948725706038e-01 -5.967437577688297e-01 -5.964923259025159e-01 -5.962405782771161e-01 + -5.959885160038786e-01 -5.957361402849749e-01 -5.954834525607696e-01 -5.952304544228757e-01 -5.949771471628894e-01 + -5.947235319540697e-01 -5.944696099654433e-01 -5.942153825546195e-01 -5.939608509107162e-01 -5.937060159741117e-01 + -5.934508794411635e-01 -5.931954428951332e-01 -5.929397071302310e-01 -5.926836734445704e-01 -5.924273432987167e-01 + -5.921707177793331e-01 -5.919137978828047e-01 -5.916565847753502e-01 -5.913990801532651e-01 -5.911412853604616e-01 + -5.908832013941032e-01 -5.906248293335863e-01 -5.903661704565201e-01 -5.901072261246485e-01 -5.898479972855557e-01 + -5.895884850905705e-01 -5.893286910470348e-01 -5.890686164387193e-01 -5.888082623596927e-01 -5.885476297953414e-01 + -5.882867200485414e-01 -5.880255342895034e-01 -5.877640732646211e-01 -5.875023385228563e-01 -5.872403317009627e-01 + -5.869780535979796e-01 -5.867155052441069e-01 -5.864526878805291e-01 -5.861896026754034e-01 -5.859262506932092e-01 + -5.856626329801135e-01 -5.853987507817091e-01 -5.851346053972879e-01 -5.848701980701103e-01 -5.846055297559873e-01 + -5.843406014627009e-01 -5.840754143260567e-01 -5.838099692919883e-01 -5.835442675863415e-01 -5.832783108438364e-01 + -5.830120998737411e-01 -5.827456354637697e-01 -5.824789190313094e-01 -5.822119517157962e-01 -5.819447343999242e-01 + -5.816772678604962e-01 -5.814095534384316e-01 -5.811415926659900e-01 -5.808733865100626e-01 -5.806049358083534e-01 + -5.803362414940428e-01 -5.800673049021045e-01 -5.797981269727348e-01 -5.795287083747186e-01 -5.792590507223763e-01 + -5.789891553127540e-01 -5.787190227795775e-01 -5.784486540773595e-01 -5.781780503537821e-01 -5.779072127885909e-01 + -5.776361421027820e-01 -5.773648392415993e-01 -5.770933058481036e-01 -5.768215427543451e-01 -5.765495506173008e-01 + -5.762773307782053e-01 -5.760048843724456e-01 -5.757322122309633e-01 -5.754593149355522e-01 -5.751861936930261e-01 + -5.749128500443350e-01 -5.746392847733658e-01 -5.743654986749642e-01 -5.740914927526973e-01 -5.738172681170074e-01 + -5.735428256834612e-01 -5.732681661997935e-01 -5.729932909950833e-01 -5.727182011898047e-01 -5.724428973589288e-01 + -5.721673806475209e-01 -5.718916522032619e-01 -5.716157126986885e-01 -5.713395629769044e-01 -5.710632040862346e-01 + -5.707866372440725e-01 -5.705098634203313e-01 -5.702328834166335e-01 -5.699556980810941e-01 -5.696783084118523e-01 + -5.694007154024264e-01 -5.691229196446771e-01 -5.688449222662509e-01 -5.685667247951188e-01 -5.682883277592247e-01 + -5.680097317796297e-01 -5.677309379467054e-01 -5.674519473718960e-01 -5.671727608332666e-01 -5.668933787438524e-01 + -5.666138024324125e-01 -5.663340332775648e-01 -5.660540719736767e-01 -5.657739191147048e-01 -5.654935755198692e-01 + -5.652130424887296e-01 -5.649323205844615e-01 -5.646514102596061e-01 -5.643703131320561e-01 -5.640890302500955e-01 + -5.638075621229782e-01 -5.635259096013298e-01 -5.632440735413435e-01 -5.629620547371306e-01 -5.626798540413637e-01 + -5.623974724401825e-01 -5.621149109968532e-01 -5.618321704141040e-01 -5.615492514232792e-01 -5.612661549867731e-01 + -5.609828820346520e-01 -5.606994332802816e-01 -5.604158091721365e-01 -5.601320109850756e-01 -5.598480400285579e-01 + -5.595638966628304e-01 -5.592795815381203e-01 -5.589950956088516e-01 -5.587104398719418e-01 -5.584256150214867e-01 + -5.581406216413944e-01 -5.578554608147975e-01 -5.575701335442586e-01 -5.572846406020895e-01 -5.569989825973618e-01 + -5.567131602740183e-01 -5.564271745453506e-01 -5.561410260628522e-01 -5.558547156725416e-01 -5.555682445647333e-01 + -5.552816133007876e-01 -5.549948224318785e-01 -5.547078730025937e-01 -5.544207659049382e-01 -5.541335017868810e-01 + -5.538460810525171e-01 -5.535585047530838e-01 -5.532707741030544e-01 -5.529828895161875e-01 -5.526948516856666e-01 + -5.524066615722431e-01 -5.521183198617187e-01 -5.518298271294942e-01 -5.515411840216864e-01 -5.512523916981388e-01 + -5.509634510475757e-01 -5.506743625070015e-01 -5.503851268106821e-01 -5.500957448096843e-01 -5.498062173123895e-01 + -5.495165448046009e-01 -5.492267279674086e-01 -5.489367680360671e-01 -5.486466657159732e-01 -5.483564214808752e-01 + -5.480660360175322e-01 -5.477755101695411e-01 -5.474848446983241e-01 -5.471940399297857e-01 -5.469030967097296e-01 + -5.466120162347039e-01 -5.463207992130580e-01 -5.460294461220425e-01 -5.457379574365921e-01 -5.454463341419615e-01 + -5.451545769787555e-01 -5.448626863052353e-01 -5.445706629798505e-01 -5.442785079610155e-01 -5.439862220351145e-01 + -5.436938056623958e-01 -5.434012594168094e-01 -5.431085842649811e-01 -5.428157805859503e-01 -5.425228488112607e-01 + -5.422297902211034e-01 -5.419366056396356e-01 -5.416432955189590e-01 -5.413498603513526e-01 -5.410563008101139e-01 + -5.407626176406882e-01 -5.404688113584152e-01 -5.401748827259091e-01 -5.398808327262222e-01 -5.395866619984641e-01 + -5.392923710452394e-01 -5.389979603718316e-01 -5.387034307479797e-01 -5.384087828255361e-01 -5.381140170098579e-01 + -5.378191341794292e-01 -5.375241352697128e-01 -5.372290208939874e-01 -5.369337913756430e-01 -5.366384472427702e-01 + -5.363429897090184e-01 -5.360474189692397e-01 -5.357517350808286e-01 -5.354559397287709e-01 -5.351600336380363e-01 + -5.348640167550405e-01 -5.345678898586708e-01 -5.342716537895550e-01 -5.339753091509816e-01 -5.336788560795809e-01 + -5.333822952812678e-01 -5.330856281219807e-01 -5.327888549366336e-01 -5.324919760228772e-01 -5.321949921530423e-01 + -5.318979038948367e-01 -5.316007117591099e-01 -5.313034163655616e-01 -5.310060185016283e-01 -5.307085188690476e-01 + -5.304109178113635e-01 -5.301132159560333e-01 -5.298154141057816e-01 -5.295175129068631e-01 -5.292195125739295e-01 + -5.289214133220888e-01 -5.286232164928936e-01 -5.283249229043371e-01 -5.280265326905970e-01 -5.277280463629660e-01 + -5.274294646406563e-01 -5.271307882435877e-01 -5.268320172699235e-01 -5.265331522204252e-01 -5.262341943956992e-01 + -5.259351442515741e-01 -5.256360020246456e-01 -5.253367683007200e-01 -5.250374438802079e-01 -5.247380293156688e-01 + -5.244385244793137e-01 -5.241389303158239e-01 -5.238392481089597e-01 -5.235394779437145e-01 -5.232396201567239e-01 + -5.229396754457293e-01 -5.226396444439171e-01 -5.223395275325885e-01 -5.220393250130385e-01 -5.217390378529512e-01 + -5.214386667612969e-01 -5.211382119631184e-01 -5.208376739941909e-01 -5.205370535049869e-01 -5.202363510969753e-01 + -5.199355670763710e-01 -5.196347019022574e-01 -5.193337564915598e-01 -5.190327313042545e-01 -5.187316266472318e-01 + -5.184304431068453e-01 -5.181291813913007e-01 -5.178278420262173e-01 -5.175264249304404e-01 -5.172249309061349e-01 + -5.169233612064826e-01 -5.166217158673360e-01 -5.163199951550123e-01 -5.160181998004911e-01 -5.157163303784532e-01 + -5.154143871836301e-01 -5.151123703899823e-01 -5.148102810445049e-01 -5.145081200022412e-01 -5.142058873966443e-01 + -5.139035834879907e-01 -5.136012088439446e-01 -5.132987643470369e-01 -5.129962500176725e-01 -5.126936660139045e-01 + -5.123910137907831e-01 -5.120882937169244e-01 -5.117855056864241e-01 -5.114826505830118e-01 -5.111797289351894e-01 + -5.108767409175631e-01 -5.105736869791608e-01 -5.102705678009448e-01 -5.099673841164564e-01 -5.096641361609235e-01 + -5.093608243087677e-01 -5.090574492425100e-01 -5.087540114820200e-01 -5.084505112619658e-01 -5.081469486274651e-01 + -5.078433245912960e-01 -5.075396400795943e-01 -5.072358951124865e-01 -5.069320899536702e-01 -5.066282251477461e-01 + -5.063243014155288e-01 -5.060203189866231e-01 -5.057162780382299e-01 -5.054121795257869e-01 -5.051080240346536e-01 + -5.048038117428125e-01 -5.044995428560932e-01 -5.041952179946867e-01 -5.038908379779851e-01 -5.035864027540428e-01 + -5.032819126747086e-01 -5.029773687584369e-01 -5.026727713803431e-01 -5.023681207203433e-01 -5.020634170773620e-01 + -5.017586611304518e-01 -5.014538534087800e-01 -5.011489939472488e-01 -5.008440834008399e-01 -5.005391225202214e-01 + -5.002341114848970e-01 -4.999290507534227e-01 -4.996239408965545e-01 -4.993187821357916e-01 -4.990135746184980e-01 + -4.987083187010172e-01 -4.984030154770353e-01 -4.980976654859903e-01 -4.977922686591017e-01 -4.974868253646026e-01 + -4.971813362150598e-01 -4.968758018164073e-01 -4.965702219796178e-01 -4.962645970518764e-01 -4.959589283986423e-01 + -4.956532161259331e-01 -4.953474601672504e-01 -4.950416611894621e-01 -4.947358197709370e-01 -4.944299362131679e-01 + -4.941240104625670e-01 -4.938180432013966e-01 -4.935120353360559e-01 -4.932059869696777e-01 -4.928998983832586e-01 + -4.925937700937396e-01 -4.922876025288242e-01 -4.919813957951697e-01 -4.916751499430368e-01 -4.913688660561277e-01 + -4.910625447982750e-01 -4.907561860728009e-01 -4.904497902858990e-01 -4.901433579647613e-01 -4.898368894758774e-01 + -4.895303847877975e-01 -4.892238442443610e-01 -4.889172690570770e-01 -4.886106594399146e-01 -4.883040152916479e-01 + -4.879973371198497e-01 -4.876906255185612e-01 -4.873838808516193e-01 -4.870771028969680e-01 -4.867702923235035e-01 + -4.864634502410182e-01 -4.861565765237592e-01 -4.858496713307078e-01 -4.855427352755911e-01 -4.852357685536697e-01 + -4.849287714451036e-01 -4.846217444589359e-01 -4.843146879997467e-01 -4.840076025123002e-01 -4.837004885060202e-01 + -4.833933461066379e-01 -4.830861755003688e-01 -4.827789772517898e-01 -4.824717516127337e-01 -4.821644988235214e-01 + -4.818572195031119e-01 -4.815499140763169e-01 -4.812425828318353e-01 -4.809352261296052e-01 -4.806278443199989e-01 + -4.803204376463540e-01 -4.800130060714603e-01 -4.797055501717924e-01 -4.793980709573083e-01 -4.790905684347367e-01 + -4.787830426340720e-01 -4.784754939887473e-01 -4.781679231200341e-01 -4.778603302286951e-01 -4.775527150015833e-01 + -4.772450784284375e-01 -4.769374213667171e-01 -4.766297434623847e-01 -4.763220450397429e-01 -4.760143266869929e-01 + -4.757065886153464e-01 -4.753988310011543e-01 -4.750910541528841e-01 -4.747832586964973e-01 -4.744754450010169e-01 + -4.741676132522562e-01 -4.738597638648681e-01 -4.735518971269201e-01 -4.732440131603057e-01 -4.729361121339242e-01 + -4.726281945136708e-01 -4.723202610280838e-01 -4.720123119889466e-01 -4.717043475548789e-01 -4.713963678930571e-01 + -4.710883732580126e-01 -4.707803639362851e-01 -4.704723402372425e-01 -4.701643027667922e-01 -4.698562520096238e-01 + -4.695481878708884e-01 -4.692401107063794e-01 -4.689320210638210e-01 -4.686239190614940e-01 -4.683158048406638e-01 + -4.680076787162389e-01 -4.676995413185929e-01 -4.673913930202820e-01 -4.670832339045677e-01 -4.667750641928977e-01 + -4.664668842720264e-01 -4.661586945788764e-01 -4.658504950199774e-01 -4.655422858974875e-01 -4.652340682220931e-01 + -4.649258420178881e-01 -4.646176071935555e-01 -4.643093642460228e-01 -4.640011135361189e-01 -4.636928552533583e-01 + -4.633845894780055e-01 -4.630763167063440e-01 -4.627680375263447e-01 -4.624597520114774e-01 -4.621514604268375e-01 + -4.618431632080228e-01 -4.615348605890552e-01 -4.612265525685530e-01 -4.609182391698630e-01 -4.606099213200685e-01 + -4.603015994943055e-01 -4.599932734377760e-01 -4.596849434943749e-01 -4.593766101319814e-01 -4.590682736286037e-01 + -4.587599339472412e-01 -4.584515913122191e-01 -4.581432465762054e-01 -4.578348999443045e-01 -4.575265513883392e-01 + -4.572182012155285e-01 -4.569098498253546e-01 -4.566014974456956e-01 -4.562931438038699e-01 -4.559847894939479e-01 + -4.556764355440957e-01 -4.553680818446301e-01 -4.550597283221777e-01 -4.547513752454754e-01 -4.544430231318768e-01 + -4.541346721146189e-01 -4.538263219879204e-01 -4.535179736207505e-01 -4.532096276207381e-01 -4.529012837320638e-01 + -4.525929421989657e-01 -4.522846033793929e-01 -4.519762674029318e-01 -4.516679344715044e-01 -4.513596049388520e-01 + -4.510512793496801e-01 -4.507429578901284e-01 -4.504346405869434e-01 -4.501263277269192e-01 -4.498180196893253e-01 + -4.495097167463535e-01 -4.492014186979058e-01 -4.488931259139300e-01 -4.485848392328776e-01 -4.482765586745183e-01 + -4.479682843350483e-01 -4.476600166157323e-01 -4.473517555800268e-01 -4.470435013321629e-01 -4.467352542154915e-01 + -4.464270145748750e-01 -4.461187827567155e-01 -4.458105590951706e-01 -4.455023436689998e-01 -4.451941365719282e-01 + -4.448859382022067e-01 -4.445777486373541e-01 -4.442695679571050e-01 -4.439613968717006e-01 -4.436532356916815e-01 + -4.433450843880059e-01 -4.430369431657580e-01 -4.427288122616561e-01 -4.424206918620519e-01 -4.421125820372482e-01 + -4.418044832064567e-01 -4.414963960811867e-01 -4.411883204960218e-01 -4.408802564087612e-01 -4.405722043668788e-01 + -4.402641646390490e-01 -4.399561373068210e-01 -4.396481224088197e-01 -4.393401203468038e-01 -4.390321316119934e-01 + -4.387241564347777e-01 -4.384161947343386e-01 -4.381082465266398e-01 -4.378003125430411e-01 -4.374923928277115e-01 + -4.371844871230922e-01 -4.368765963346815e-01 -4.365687207997857e-01 -4.362608601883623e-01 -4.359530147661063e-01 + -4.356451849773876e-01 -4.353373711547212e-01 -4.350295729831375e-01 -4.347217906709347e-01 -4.344140253247259e-01 + -4.341062767701542e-01 -4.337985447574569e-01 -4.334908298973194e-01 -4.331831324142745e-01 -4.328754522838512e-01 + -4.325677895304312e-01 -4.322601446380396e-01 -4.319525182069930e-01 -4.316449103351276e-01 -4.313373209430619e-01 + -4.310297500384340e-01 -4.307221981580691e-01 -4.304146654764764e-01 -4.301071518609876e-01 -4.297996578556980e-01 + -4.294921838432407e-01 -4.291847298181669e-01 -4.288772959356691e-01 -4.285698824691314e-01 -4.282624896947286e-01 + -4.279551173581843e-01 -4.276477655542056e-01 -4.273404353166645e-01 -4.270331268873108e-01 -4.267258400671970e-01 + -4.264185747737768e-01 -4.261113314513503e-01 -4.258041105111009e-01 -4.254969114260224e-01 -4.251897346526543e-01 + -4.248825811839114e-01 -4.245754507348872e-01 -4.242683433304872e-01 -4.239612594489042e-01 -4.236541990429175e-01 + -4.233471621233121e-01 -4.230401489624036e-01 -4.227331599159186e-01 -4.224261953202194e-01 -4.221192554076946e-01 + -4.218123401221037e-01 -4.215054495276057e-01 -4.211985840665567e-01 -4.208917437341202e-01 -4.205849285470991e-01 + -4.202781391077526e-01 -4.199713756820169e-01 -4.196646382796324e-01 -4.193579269625680e-01 -4.190512419898234e-01 + -4.187445835885104e-01 -4.184379514023820e-01 -4.181313458657921e-01 -4.178247679943504e-01 -4.175182174706034e-01 + -4.172116941638125e-01 -4.169051985589959e-01 -4.165987308801878e-01 -4.162922910262470e-01 -4.159858787333477e-01 + -4.156794948456864e-01 -4.153731400237493e-01 -4.150668138055245e-01 -4.147605162480433e-01 -4.144542477033889e-01 + -4.141480084083939e-01 -4.138417983331389e-01 -4.135356175072968e-01 -4.132294665425894e-01 -4.129233456523720e-01 + -4.126172547353913e-01 -4.123111939769975e-01 -4.120051637027982e-01 -4.116991641480549e-01 -4.113931948631621e-01 + -4.110872561089984e-01 -4.107813489720965e-01 -4.104754732505308e-01 -4.101696286974395e-01 -4.098638156566466e-01 + -4.095580344057681e-01 -4.092522850492459e-01 -4.089465675148873e-01 -4.086408821301867e-01 -4.083352292811099e-01 + -4.080296090087697e-01 -4.077240214925531e-01 -4.074184669621912e-01 -4.071129454474836e-01 -4.068074568206541e-01 + -4.065020011172992e-01 -4.061965792344674e-01 -4.058911914234347e-01 -4.055858372701102e-01 -4.052805169731385e-01 + -4.049752308691225e-01 -4.046699791746853e-01 -4.043647616984872e-01 -4.040595785275335e-01 -4.037544302850327e-01 + -4.034493171430220e-01 -4.031442391412985e-01 -4.028391964411297e-01 -4.025341890399178e-01 -4.022292169515432e-01 + -4.019242804318620e-01 -4.016193797575413e-01 -4.013145151618574e-01 -4.010096867767989e-01 -4.007048946739946e-01 + -4.004001389575452e-01 -4.000954199442892e-01 -3.997907376333255e-01 -3.994860918450180e-01 -3.991814831388100e-01 + -3.988769118682245e-01 -3.985723779299208e-01 -3.982678813725196e-01 -3.979634224118638e-01 -3.976590013430957e-01 + -3.973546179557737e-01 -3.970502723184750e-01 -3.967459652757308e-01 -3.964416967373386e-01 -3.961374664325438e-01 + -3.958332748416728e-01 -3.955291221412219e-01 -3.952250082276700e-01 -3.949209329883424e-01 -3.946168969005399e-01 + -3.943129006192436e-01 -3.940089438207542e-01 -3.937050264421336e-01 -3.934011488327164e-01 -3.930973111392007e-01 + -3.927935133510078e-01 -3.924897554398895e-01 -3.921860379028622e-01 -3.918823611410527e-01 -3.915787251272155e-01 + -3.912751296302741e-01 -3.909715747221262e-01 -3.906680610479274e-01 -3.903645884467465e-01 -3.900611567141484e-01 + -3.897577665105899e-01 -3.894544180732338e-01 -3.891511112918067e-01 -3.888478460867855e-01 -3.885446227676595e-01 + -3.882414417069796e-01 -3.879383024897914e-01 -3.876352053351357e-01 -3.873321510269954e-01 -3.870291394376005e-01 + -3.867261704550462e-01 -3.864232442776043e-01 -3.861203610538394e-01 -3.858175208256477e-01 -3.855147235659399e-01 + -3.852119696012977e-01 -3.849092593053318e-01 -3.846065928280623e-01 -3.843039700003283e-01 -3.840013907871894e-01 + -3.836988557264463e-01 -3.833963646642737e-01 -3.830939173673272e-01 -3.827915146861536e-01 -3.824891567344230e-01 + -3.821868431312930e-01 -3.818845742897094e-01 -3.815823505036508e-01 -3.812801717050347e-01 -3.809780375081945e-01 + -3.806759481537249e-01 -3.803739045452896e-01 -3.800719066553854e-01 -3.797699542729503e-01 -3.794680474344709e-01 + -3.791661864151066e-01 -3.788643713579414e-01 -3.785626020610045e-01 -3.782608787892401e-01 -3.779592019649877e-01 + -3.776575717504184e-01 -3.773559879986245e-01 -3.770544506277551e-01 -3.767529601718599e-01 -3.764515165488658e-01 + -3.761501194541416e-01 -3.758487697291592e-01 -3.755474675286999e-01 -3.752462123142175e-01 -3.749450044400430e-01 + -3.746438442933219e-01 -3.743427319385532e-01 -3.740416670860849e-01 -3.737406497610264e-01 -3.734396805632812e-01 + -3.731387597991040e-01 -3.728378873981389e-01 -3.725370629746288e-01 -3.722362869751284e-01 -3.719355598195744e-01 + -3.716348809475082e-01 -3.713342505611615e-01 -3.710336692885385e-01 -3.707331373206220e-01 -3.704326544188714e-01 + -3.701322203470578e-01 -3.698318357923215e-01 -3.695315007664240e-01 -3.692312147431765e-01 -3.689309784821330e-01 + -3.686307923312130e-01 -3.683306558583173e-01 -3.680305692832940e-01 -3.677305328772401e-01 -3.674305466155561e-01 + -3.671306102835627e-01 -3.668307239979260e-01 -3.665308885123383e-01 -3.662311039528895e-01 -3.659313700864294e-01 + -3.656316867340536e-01 -3.653320542170925e-01 -3.650324728818179e-01 -3.647329423252613e-01 -3.644334627823841e-01 + -3.641340348652060e-01 -3.638346584224414e-01 -3.635353333854674e-01 -3.632360599381753e-01 -3.629368383087880e-01 + -3.626376683911322e-01 -3.623385498640058e-01 -3.620394834143431e-01 -3.617404694429358e-01 -3.614415075289109e-01 + -3.611425978472304e-01 -3.608437406892576e-01 -3.605449360396625e-01 -3.602461837170217e-01 -3.599474837636126e-01 + -3.596488368123176e-01 -3.593502429497555e-01 -3.590517019950174e-01 -3.587532141258951e-01 -3.584547794364419e-01 + -3.581563978967544e-01 -3.578580694598877e-01 -3.575597943932133e-01 -3.572615731273898e-01 -3.569634054963255e-01 + -3.566652915450074e-01 -3.563672316398869e-01 -3.560692255181004e-01 -3.557712730433470e-01 -3.554733745722332e-01 + -3.551755304325120e-01 -3.548777407381354e-01 -3.545800053200450e-01 -3.542823243820459e-01 -3.539846981602633e-01 + -3.536871265064687e-01 -3.533896092936707e-01 -3.530921466577667e-01 -3.527947392696623e-01 -3.524973870763591e-01 + -3.522000896417020e-01 -3.519028473926252e-01 -3.516056606257513e-01 -3.513085292624320e-01 -3.510114529438408e-01 + -3.507144318797571e-01 -3.504174668509267e-01 -3.501205576763053e-01 -3.498237041407538e-01 -3.495269064579332e-01 + -3.492301648012658e-01 -3.489334792023763e-01 -3.486368495320163e-01 -3.483402759532310e-01 -3.480437587608516e-01 + -3.477472981563033e-01 -3.474508940116457e-01 -3.471545462266357e-01 -3.468582552838557e-01 -3.465620210594309e-01 + -3.462658431862374e-01 -3.459697223261950e-01 -3.456736587298253e-01 -3.453776521244075e-01 -3.450817025977070e-01 + -3.447858103250944e-01 -3.444899754033867e-01 -3.441941976114102e-01 -3.438984770490408e-01 -3.436028143288083e-01 + -3.433072093931014e-01 -3.430116620696204e-01 -3.427161725111446e-01 -3.424207408695913e-01 -3.421253671506906e-01 + -3.418300511322294e-01 -3.415347931565998e-01 -3.412395936962896e-01 -3.409444525560181e-01 -3.406493696743920e-01 + -3.403543451949735e-01 -3.400593792856730e-01 -3.397644718554241e-01 -3.394696227303268e-01 -3.391748324448361e-01 + -3.388801012525273e-01 -3.385854289098167e-01 -3.382908154719833e-01 -3.379962610967925e-01 -3.377017658856785e-01 + -3.374073296405456e-01 -3.371129523992028e-01 -3.368186347618567e-01 -3.365243767275647e-01 -3.362301780997549e-01 + -3.359360390044588e-01 -3.356419595939377e-01 -3.353479398983790e-01 -3.350539796822969e-01 -3.347600792157354e-01 + -3.344662390001809e-01 -3.341724588683134e-01 -3.338787387386647e-01 -3.335850787505256e-01 -3.332914790393797e-01 + -3.329979395469141e-01 -3.327044601082655e-01 -3.324110411740308e-01 -3.321176830325031e-01 -3.318243854727410e-01 + -3.315311485033696e-01 -3.312379722613320e-01 -3.309448568815591e-01 -3.306518021855764e-01 -3.303588081394571e-01 + -3.300658753265905e-01 -3.297730038003383e-01 -3.294801933460689e-01 -3.291874440822869e-01 -3.288947561448500e-01 + -3.286021295596533e-01 -3.283095641084477e-01 -3.280170600152969e-01 -3.277246178092963e-01 -3.274322373144385e-01 + -3.271399184133136e-01 -3.268476612759387e-01 -3.265554660369243e-01 -3.262633326374516e-01 -3.259712608638953e-01 + -3.256792511518811e-01 -3.253873038511834e-01 -3.250954187049387e-01 -3.248035957166725e-01 -3.245118350464998e-01 + -3.242201368055027e-01 -3.239285008232202e-01 -3.236369270127419e-01 -3.233454159517716e-01 -3.230539677655248e-01 + -3.227625822208953e-01 -3.224712593689608e-01 -3.221799993547627e-01 -3.218888022707884e-01 -3.215976678728723e-01 + -3.213065962862219e-01 -3.210155880538063e-01 -3.207246430922022e-01 -3.204337612603162e-01 -3.201429426545060e-01 + -3.198521874188910e-01 -3.195614955407240e-01 -3.192708667833873e-01 -3.189803015317205e-01 -3.186898001852494e-01 + -3.183993624745159e-01 -3.181089883645859e-01 -3.178186780215274e-01 -3.175284315788672e-01 -3.172382488912609e-01 + -3.169481298117736e-01 -3.166580748847834e-01 -3.163680842820584e-01 -3.160781577505636e-01 -3.157882953403168e-01 + -3.154984971942622e-01 -3.152087634033934e-01 -3.149190937439705e-01 -3.146294882798918e-01 -3.143399475483734e-01 + -3.140504715109739e-01 -3.137610600081304e-01 -3.134717131245625e-01 -3.131824310053718e-01 -3.128932136614712e-01 + -3.126040608259110e-01 -3.123149728003283e-01 -3.120259500284038e-01 -3.117369923103007e-01 -3.114480995811182e-01 + -3.111592719695180e-01 -3.108705096041851e-01 -3.105818123704323e-01 -3.102931800853200e-01 -3.100046132424714e-01 + -3.097161120700553e-01 -3.094276763275429e-01 -3.091393060498078e-01 -3.088510013669117e-01 -3.085627623567511e-01 + -3.082745888090075e-01 -3.079864807413559e-01 -3.076984387104112e-01 -3.074104627037881e-01 -3.071225525229602e-01 + -3.068347082674415e-01 -3.065469300647063e-01 -3.062592179233167e-01 -3.059715715883658e-01 -3.056839913222955e-01 + -3.053964776128304e-01 -3.051090302429263e-01 -3.048216491115613e-01 -3.045343343664140e-01 -3.042470861256498e-01 + -3.039599042912569e-01 -3.036727886539801e-01 -3.033857396783212e-01 -3.030987576532087e-01 -3.028118423290159e-01 + -3.025249936916685e-01 -3.022382118572411e-01 -3.019514969324824e-01 -3.016648487319269e-01 -3.013782672163520e-01 + -3.010917529380510e-01 -3.008053059332530e-01 -3.005189259718208e-01 -3.002326131255288e-01 -2.999463675243501e-01 + -2.996601892115071e-01 -2.993740779431134e-01 -2.990880338991673e-01 -2.988020575697556e-01 -2.985161488129333e-01 + -2.982303074956766e-01 -2.979445337070337e-01 -2.976588275957710e-01 -2.973731891105994e-01 -2.970876179949718e-01 + -2.968021146693378e-01 -2.965166794729635e-01 -2.962313121299224e-01 -2.959460126205053e-01 -2.956607810824475e-01 + -2.953756176130727e-01 -2.950905220348498e-01 -2.948054942542040e-01 -2.945205348259674e-01 -2.942356438398593e-01 + -2.939508210351428e-01 -2.936660664737455e-01 -2.933813802767271e-01 -2.930967624892026e-01 -2.928122128931882e-01 + -2.925277316158055e-01 -2.922433191494531e-01 -2.919589753765323e-01 -2.916747001400424e-01 -2.913904935350139e-01 + -2.911063557118664e-01 -2.908222866434848e-01 -2.905382860439090e-01 -2.902543542778646e-01 -2.899704917370004e-01 + -2.896866981425306e-01 -2.894029734511842e-01 -2.891193178139609e-01 -2.888357313345801e-01 -2.885522138545054e-01 + -2.882687652243500e-01 -2.879853859636904e-01 -2.877020762131379e-01 -2.874188357014512e-01 -2.871356645025479e-01 + -2.868525627422169e-01 -2.865695304469716e-01 -2.862865673963798e-01 -2.860036736642309e-01 -2.857208497673618e-01 + -2.854380956360413e-01 -2.851554110854154e-01 -2.848727961880673e-01 -2.845902510831507e-01 -2.843077757793696e-01 + -2.840253700094237e-01 -2.837430340397069e-01 -2.834607682748240e-01 -2.831785725328111e-01 -2.828964467316310e-01 + -2.826143909542473e-01 -2.823324053101364e-01 -2.820504896922502e-01 -2.817686439371250e-01 -2.814868685136343e-01 + -2.812051636152371e-01 -2.809235289745332e-01 -2.806419646055033e-01 -2.803604706362606e-01 -2.800790471610514e-01 + -2.797976939416736e-01 -2.795164109639519e-01 -2.792351987736799e-01 -2.789540573481899e-01 -2.786729864814172e-01 + -2.783919862645312e-01 -2.781110567914744e-01 -2.778301980476193e-01 -2.775494098202491e-01 -2.772686923282846e-01 + -2.769880459823117e-01 -2.767074706347814e-01 -2.764269661749121e-01 -2.761465326612197e-01 -2.758661702373058e-01 + -2.755858788282252e-01 -2.753056582075042e-01 -2.750255088041456e-01 -2.747454308713073e-01 -2.744654241403574e-01 + -2.741854886058927e-01 -2.739056243892176e-01 -2.736258315782464e-01 -2.733461099674180e-01 -2.730664595012521e-01 + -2.727868807168794e-01 -2.725073736368404e-01 -2.722279380246611e-01 -2.719485739535283e-01 -2.716692815376729e-01 + -2.713900607905190e-01 -2.711109114418696e-01 -2.708318336740216e-01 -2.705528279896257e-01 -2.702738942089605e-01 + -2.699950321750810e-01 -2.697162419812612e-01 -2.694375237750356e-01 -2.691588774953904e-01 -2.688803028674867e-01 + -2.686018002777490e-01 -2.683233700490228e-01 -2.680450119322323e-01 -2.677667258920440e-01 -2.674885120321642e-01 + -2.672103704327183e-01 -2.669323009240009e-01 -2.666543034142266e-01 -2.663763784024609e-01 -2.660985259744725e-01 + -2.658207458961011e-01 -2.655430381891060e-01 -2.652654029648259e-01 -2.649878402880381e-01 -2.647103499069445e-01 + -2.644329319184849e-01 -2.641555868035665e-01 -2.638783144422805e-01 -2.636011146840161e-01 -2.633239876271375e-01 + -2.630469333706403e-01 -2.627699518665801e-01 -2.624930428881614e-01 -2.622162067361601e-01 -2.619394437425979e-01 + -2.616627537197243e-01 -2.613861365959049e-01 -2.611095924398818e-01 -2.608331213683194e-01 -2.605567232565551e-01 + -2.602803979638560e-01 -2.600041459185203e-01 -2.597279672559259e-01 -2.594518617711524e-01 -2.591758294668244e-01 + -2.588998704444723e-01 -2.586239847880919e-01 -2.583481722507706e-01 -2.580724328621725e-01 -2.577967671126083e-01 + -2.575211749406902e-01 -2.572456561780725e-01 -2.569702108956164e-01 -2.566948391959332e-01 -2.564195410517088e-01 + -2.561443162003717e-01 -2.558691649278121e-01 -2.555940876367002e-01 -2.553190840839927e-01 -2.550441541814838e-01 + -2.547692980445108e-01 -2.544945157803290e-01 -2.542198072584164e-01 -2.539451722830000e-01 -2.536706112997469e-01 + -2.533961245035316e-01 -2.531217116489478e-01 -2.528473727232912e-01 -2.525731078267265e-01 -2.522989170513077e-01 + -2.520248001810547e-01 -2.517507572028029e-01 -2.514767886096237e-01 -2.512028943623831e-01 -2.509290742545349e-01 + -2.506553283625735e-01 -2.503816568034038e-01 -2.501080595782905e-01 -2.498345364108095e-01 -2.495610875124447e-01 + -2.492877133133172e-01 -2.490144136112123e-01 -2.487411882994743e-01 -2.484680374856057e-01 -2.481949612635986e-01 + -2.479219595287280e-01 -2.476490320734136e-01 -2.473761793087864e-01 -2.471034014703498e-01 -2.468306982957061e-01 + -2.465580697844871e-01 -2.462855160432138e-01 -2.460130371204629e-01 -2.457406328233614e-01 -2.454683031113906e-01 + -2.451960484794311e-01 -2.449238689415910e-01 -2.446517642712055e-01 -2.443797345227543e-01 -2.441077797933181e-01 + -2.438359000947776e-01 -2.435640951889690e-01 -2.432923652315951e-01 -2.430207106571287e-01 -2.427491313175689e-01 + -2.424776270783986e-01 -2.422061980074125e-01 -2.419348442072336e-01 -2.416635656192684e-01 -2.413923620306189e-01 + -2.411212337762792e-01 -2.408501811283544e-01 -2.405792038734625e-01 -2.403083019688687e-01 -2.400374754936993e-01 + -2.397667245256450e-01 -2.394960488977194e-01 -2.392254485194238e-01 -2.389549238762380e-01 -2.386844750244205e-01 + -2.384141017100180e-01 -2.381438039886236e-01 -2.378735819631148e-01 -2.376034356560101e-01 -2.373333648418426e-01 + -2.370633696160408e-01 -2.367934504134751e-01 -2.365236071336530e-01 -2.362538396334552e-01 -2.359841479713349e-01 + -2.357145322333765e-01 -2.354449923780104e-01 -2.351755281955192e-01 -2.349061399838227e-01 -2.346368280467886e-01 + -2.343675921502802e-01 -2.340984322401892e-01 -2.338293484224673e-01 -2.335603407944267e-01 -2.332914091991481e-01 + -2.330225534791031e-01 -2.327537740958542e-01 -2.324850711724544e-01 -2.322164444575208e-01 -2.319478939696494e-01 + -2.316794198107119e-01 -2.314110220364787e-01 -2.311427004172850e-01 -2.308744549913938e-01 -2.306062862221652e-01 + -2.303381940399467e-01 -2.300701782673901e-01 -2.298022389505013e-01 -2.295343762055658e-01 -2.292665900251787e-01 + -2.289988801367178e-01 -2.287312467963517e-01 -2.284636903804389e-01 -2.281962106639611e-01 -2.279288075702767e-01 + -2.276614812041137e-01 -2.273942316314865e-01 -2.271270587234099e-01 -2.268599623216859e-01 -2.265929428586625e-01 + -2.263260004971463e-01 -2.260591349680134e-01 -2.257923462859340e-01 -2.255256345570404e-01 -2.252589998316905e-01 + -2.249924418873443e-01 -2.247259607239798e-01 -2.244595568451081e-01 -2.241932301870257e-01 -2.239269805236896e-01 + -2.236608079513920e-01 -2.233947125724077e-01 -2.231286943677930e-01 -2.228627530899186e-01 -2.225968889349937e-01 + -2.223311022938890e-01 -2.220653929888047e-01 -2.217997609137618e-01 -2.215342061492806e-01 -2.212687287997047e-01 + -2.210033287645195e-01 -2.207380058226258e-01 -2.204727603658667e-01 -2.202075926188733e-01 -2.199425023254976e-01 + -2.196774894791217e-01 -2.194125541827232e-01 -2.191476964953657e-01 -2.188829162198361e-01 -2.186182133017065e-01 + -2.183535882155842e-01 -2.180890409721393e-01 -2.178245713492862e-01 -2.175601793915103e-01 -2.172958651996608e-01 + -2.170316287941991e-01 -2.167674699222372e-01 -2.165033887351043e-01 -2.162393856655618e-01 -2.159754605317784e-01 + -2.157116131976179e-01 -2.154478437626437e-01 -2.151841523053365e-01 -2.149205387568082e-01 -2.146570029331132e-01 + -2.143935451423346e-01 -2.141301656253313e-01 -2.138668641770334e-01 -2.136036407648879e-01 -2.133404954698548e-01 + -2.130774283590253e-01 -2.128144392711416e-01 -2.125515281171839e-01 -2.122886953403734e-01 -2.120259409959825e-01 + -2.117632648531722e-01 -2.115006669388265e-01 -2.112381473557379e-01 -2.109757061544524e-01 -2.107133431005909e-01 + -2.104510582708100e-01 -2.101888520817322e-01 -2.099267244352251e-01 -2.096646751892664e-01 -2.094027043922436e-01 + -2.091408121382980e-01 -2.088789983898283e-01 -2.086172629233026e-01 -2.083556060294393e-01 -2.080940280081475e-01 + -2.078325286261216e-01 -2.075711078316715e-01 -2.073097657230958e-01 -2.070485023681648e-01 -2.067873176254528e-01 + -2.065262113703670e-01 -2.062651840261599e-01 -2.060042356935543e-01 -2.057433661320316e-01 -2.054825753736384e-01 + -2.052218635119340e-01 -2.049612305777034e-01 -2.047006763593381e-01 -2.044402009029163e-01 -2.041798046444743e-01 + -2.039194875091236e-01 -2.036592493288050e-01 -2.033990901597007e-01 -2.031390101041152e-01 -2.028790091364410e-01 + -2.026190869860804e-01 -2.023592439213894e-01 -2.020994803209571e-01 -2.018397959336108e-01 -2.015801906636277e-01 + -2.013206646163115e-01 -2.010612178968381e-01 -2.008018503846473e-01 -2.005425618909167e-01 -2.002833527994660e-01 + -2.000242232866459e-01 -1.997651731545872e-01 -1.995062023757428e-01 -1.992473110134654e-01 -1.989884991329442e-01 + -1.987297665552775e-01 -1.984711132804359e-01 -1.982125397288479e-01 -1.979540458641874e-01 -1.976956315048893e-01 + -1.974372966986851e-01 -1.971790415364275e-01 -1.969208660181268e-01 -1.966627699138122e-01 -1.964047534115951e-01 + -1.961468168792641e-01 -1.958889601415059e-01 -1.956311830976701e-01 -1.953734858227050e-01 -1.951158683885618e-01 + -1.948583307060198e-01 -1.946008726082255e-01 -1.943434944554087e-01 -1.940861964418109e-01 -1.938289783248288e-01 + -1.935718400929853e-01 -1.933147818435645e-01 -1.930578036445209e-01 -1.928009053047615e-01 -1.925440867668252e-01 + -1.922873484836986e-01 -1.920306904586313e-01 -1.917741124759950e-01 -1.915176145882685e-01 -1.912611968971867e-01 + -1.910048594156118e-01 -1.907486018758652e-01 -1.904924244300230e-01 -1.902363275204000e-01 -1.899803109613821e-01 + -1.897243746214878e-01 -1.894685186111405e-01 -1.892127429944364e-01 -1.889570476814606e-01 -1.887014324762902e-01 + -1.884458977092228e-01 -1.881904436322386e-01 -1.879350700181010e-01 -1.876797768445363e-01 -1.874245641980662e-01 + -1.871694321106837e-01 -1.869143804464632e-01 -1.866594091449939e-01 -1.864045185802509e-01 -1.861497088150435e-01 + -1.858949796742653e-01 -1.856403311585743e-01 -1.853857633524328e-01 -1.851312763093270e-01 -1.848768697910832e-01 + -1.846225438828809e-01 -1.843682990131126e-01 -1.841141350478542e-01 -1.838600518410295e-01 -1.836060494900988e-01 + -1.833521280737523e-01 -1.830982875326949e-01 -1.828445276569093e-01 -1.825908487213151e-01 -1.823372510073639e-01 + -1.820837342990139e-01 -1.818302985608840e-01 -1.815769438919524e-01 -1.813236703339543e-01 -1.810704777470943e-01 + -1.808173660274447e-01 -1.805643355946649e-01 -1.803113865319381e-01 -1.800585185867421e-01 -1.798057318207557e-01 + -1.795530263298101e-01 -1.793004021140676e-01 -1.790478589821669e-01 -1.787953969871552e-01 -1.785430165333783e-01 + -1.782907175616041e-01 -1.780384999147782e-01 -1.777863636186671e-01 -1.775343087850783e-01 -1.772823354138563e-01 + -1.770304432439544e-01 -1.767786324996124e-01 -1.765269035206169e-01 -1.762752561209628e-01 -1.760236902365481e-01 + -1.757722059508868e-01 -1.755208033072168e-01 -1.752694821962465e-01 -1.750182424985018e-01 -1.747670845873172e-01 + -1.745160085943736e-01 -1.742650142826787e-01 -1.740141016708582e-01 -1.737632708599284e-01 -1.735125219002990e-01 + -1.732618545819516e-01 -1.730112688968157e-01 -1.727607652962038e-01 -1.725103437360838e-01 -1.722600040199003e-01 + -1.720097462053399e-01 -1.717595703957765e-01 -1.715094765937824e-01 -1.712594645505801e-01 -1.710095344617568e-01 + -1.707596867053610e-01 -1.705099210652020e-01 -1.702602374503936e-01 -1.700106359820640e-01 -1.697611167032507e-01 + -1.695116795170456e-01 -1.692623242857098e-01 -1.690130513415946e-01 -1.687638608735592e-01 -1.685147526839133e-01 + -1.682657267304136e-01 -1.680167830834059e-01 -1.677679218434041e-01 -1.675191428301483e-01 -1.672704459776749e-01 + -1.670218317162355e-01 -1.667733000505553e-01 -1.665248507843929e-01 -1.662764839848620e-01 -1.660281997331086e-01 + -1.657799980211539e-01 -1.655318786421316e-01 -1.652838417439954e-01 -1.650358877061586e-01 -1.647880163635810e-01 + -1.645402275978841e-01 -1.642925215033296e-01 -1.640448981629310e-01 -1.637973575048030e-01 -1.635498993322754e-01 + -1.633025239587731e-01 -1.630552316214122e-01 -1.628080220971913e-01 -1.625608953706327e-01 -1.623138515347123e-01 + -1.620668906280902e-01 -1.618200125176413e-01 -1.615732171440627e-01 -1.613265048790783e-01 -1.610798757703294e-01 + -1.608333296326273e-01 -1.605868664946396e-01 -1.603404864451659e-01 -1.600941895233320e-01 -1.598479755194739e-01 + -1.596018445089071e-01 -1.593557968710357e-01 -1.591098325274174e-01 -1.588639513462271e-01 -1.586181533501567e-01 + -1.583724386633118e-01 -1.581268072684121e-01 -1.578812589110151e-01 -1.576357938605635e-01 -1.573904124176000e-01 + -1.571451143885420e-01 -1.568998997115455e-01 -1.566547684551118e-01 -1.564097207009810e-01 -1.561647563377750e-01 + -1.559198752534892e-01 -1.556750777971572e-01 -1.554303640753041e-01 -1.551857339241298e-01 -1.549411873472499e-01 + -1.546967244117141e-01 -1.544523451583313e-01 -1.542080493972972e-01 -1.539638371771692e-01 -1.537197089019022e-01 + -1.534756644902717e-01 -1.532317037874507e-01 -1.529878268669247e-01 -1.527440338285302e-01 -1.525003246495042e-01 + -1.522566990917994e-01 -1.520131573865194e-01 -1.517696998607227e-01 -1.515263263105132e-01 -1.512830366842278e-01 + -1.510398310896279e-01 -1.507967095609423e-01 -1.505536719818633e-01 -1.503107182379510e-01 -1.500678487166025e-01 + -1.498250635429138e-01 -1.495823624607518e-01 -1.493397455183047e-01 -1.490972128240516e-01 -1.488547643939502e-01 + -1.486124000468938e-01 -1.483701197975273e-01 -1.481279240643807e-01 -1.478858128086334e-01 -1.476437858541442e-01 + -1.474018432575297e-01 -1.471599850901578e-01 -1.469182113447434e-01 -1.466765218581870e-01 -1.464349167991909e-01 + -1.461933964691583e-01 -1.459519607332137e-01 -1.457106095126376e-01 -1.454693428712828e-01 -1.452281609001614e-01 + -1.449870635167667e-01 -1.447460505411944e-01 -1.445051223204885e-01 -1.442642790465533e-01 -1.440235204958664e-01 + -1.437828466645076e-01 -1.435422576460715e-01 -1.433017535021517e-01 -1.430613340788666e-01 -1.428209993367665e-01 + -1.425807496580667e-01 -1.423405850452980e-01 -1.421005053276286e-01 -1.418605105748216e-01 -1.416206008760722e-01 + -1.413807762310167e-01 -1.411410364179444e-01 -1.409013815814383e-01 -1.406618121114770e-01 -1.404223278620860e-01 + -1.401829287142080e-01 -1.399436147388266e-01 -1.397043860171121e-01 -1.394652424999606e-01 -1.392261840277533e-01 + -1.389872108800275e-01 -1.387483232704581e-01 -1.385095210193419e-01 -1.382708041155041e-01 -1.380321726381191e-01 + -1.377936266235328e-01 -1.375551659356028e-01 -1.373167905196480e-01 -1.370785007699294e-01 -1.368402967462084e-01 + -1.366021782602805e-01 -1.363641453151502e-01 -1.361261980034910e-01 -1.358883363925467e-01 -1.356505602730137e-01 + -1.354128697173978e-01 -1.351752651019714e-01 -1.349377463365720e-01 -1.347003133096952e-01 -1.344629660943524e-01 + -1.342257047644556e-01 -1.339885292721434e-01 -1.337514394288152e-01 -1.335144355004790e-01 -1.332775177574095e-01 + -1.330406860095451e-01 -1.328039402156265e-01 -1.325672804621033e-01 -1.323307068237664e-01 -1.320942191803451e-01 + -1.318578174250235e-01 -1.316215019436967e-01 -1.313852728254415e-01 -1.311491298574344e-01 -1.309130730812647e-01 + -1.306771025967214e-01 -1.304412184433993e-01 -1.302054204167683e-01 -1.299697085633917e-01 -1.297340833011096e-01 + -1.294985445422908e-01 -1.292630921400970e-01 -1.290277262032818e-01 -1.287924468024440e-01 -1.285572538860320e-01 + -1.283221472565841e-01 -1.280871271607027e-01 -1.278521939245786e-01 -1.276173473594251e-01 -1.273825873815436e-01 + -1.271479140654554e-01 -1.269133275291332e-01 -1.266788276689478e-01 -1.264444143112885e-01 -1.262100878411512e-01 + -1.259758484249543e-01 -1.257416958580221e-01 -1.255076301118343e-01 -1.252736512740011e-01 -1.250397594556589e-01 + -1.248059544551782e-01 -1.245722362561283e-01 -1.243386053032582e-01 -1.241050615437150e-01 -1.238716047916152e-01 + -1.236382351439431e-01 -1.234049527007845e-01 -1.231717574487822e-01 -1.229386491649988e-01 -1.227056280466961e-01 + -1.224726944551588e-01 -1.222398481939305e-01 -1.220070891810755e-01 -1.217744175349468e-01 -1.215418333321439e-01 + -1.213093364896874e-01 -1.210769268543440e-01 -1.208446047468073e-01 -1.206123703546746e-01 -1.203802234985189e-01 + -1.201481641556592e-01 -1.199161924040098e-01 -1.196843083373426e-01 -1.194525118101599e-01 -1.192208027778711e-01 + -1.189891816158967e-01 -1.187576483334740e-01 -1.185262027772708e-01 -1.182948450325541e-01 -1.180635751718018e-01 + -1.178323931740712e-01 -1.176012988598141e-01 -1.173702923768903e-01 -1.171393740841554e-01 -1.169085438684581e-01 + -1.166778016318426e-01 -1.164471474323627e-01 -1.162165813372163e-01 -1.159861033094216e-01 -1.157557132288848e-01 + -1.155254113554128e-01 -1.152951978878259e-01 -1.150650726784410e-01 -1.148350356935617e-01 -1.146050869998271e-01 + -1.143752266983624e-01 -1.141454546633286e-01 -1.139157708150553e-01 -1.136861755297615e-01 -1.134566688685596e-01 + -1.132272506625232e-01 -1.129979209389772e-01 -1.127686797968139e-01 -1.125395272939830e-01 -1.123104632216639e-01 + -1.120814876598629e-01 -1.118526009932446e-01 -1.116238031362107e-01 -1.113950939743172e-01 -1.111664735714766e-01 + -1.109379420230661e-01 -1.107094992989161e-01 -1.104811452047023e-01 -1.102528800189790e-01 -1.100247040176238e-01 + -1.097966169898620e-01 -1.095686189066022e-01 -1.093407098806465e-01 -1.091128899944971e-01 -1.088851591239916e-01 + -1.086575171512236e-01 -1.084299644451029e-01 -1.082025011238454e-01 -1.079751270251657e-01 -1.077478421434466e-01 + -1.075206465724022e-01 -1.072935404061887e-01 -1.070665234272605e-01 -1.068395956686409e-01 -1.066127575621145e-01 + -1.063860090403522e-01 -1.061593499609373e-01 -1.059327804074918e-01 -1.057063004552603e-01 -1.054799100848440e-01 + -1.052536091459819e-01 -1.050273978363624e-01 -1.048012764247322e-01 -1.045752447992682e-01 -1.043493029044653e-01 + -1.041234507912105e-01 -1.038976885616201e-01 -1.036720161437409e-01 -1.034464334142674e-01 -1.032209407082870e-01 + -1.029955381585720e-01 -1.027702255852857e-01 -1.025450030256683e-01 -1.023198705766582e-01 -1.020948282803886e-01 + -1.018698759615270e-01 -1.016450136357437e-01 -1.014202417243671e-01 -1.011955602054591e-01 -1.009709689162001e-01 + -1.007464679013254e-01 -1.005220572777319e-01 -1.002977370772110e-01 -1.000735070732387e-01 -9.984936745539402e-02 + -9.962531858349888e-02 -9.940136027998529e-02 -9.917749246814733e-02 -9.895371525770333e-02 -9.873002873335845e-02 + -9.850643282337790e-02 -9.828292738770521e-02 -9.805951276903688e-02 -9.783618914357473e-02 -9.761295629040607e-02 + -9.738981424317925e-02 -9.716676311420755e-02 -9.694380293900719e-02 -9.672093359332221e-02 -9.649815506782670e-02 + -9.627546771326484e-02 -9.605287156919239e-02 -9.583036651098850e-02 -9.560795255252680e-02 -9.538562978098189e-02 + -9.516339824129488e-02 -9.494125774199282e-02 -9.471920843970391e-02 -9.449725071216948e-02 -9.427538438593883e-02 + -9.405360936874554e-02 -9.383192580278800e-02 -9.361033376064058e-02 -9.338883317577901e-02 -9.316742389906425e-02 + -9.294610622995669e-02 -9.272488039403920e-02 -9.250374621386263e-02 -9.228270367992475e-02 -9.206175287916113e-02 + -9.184089387273792e-02 -9.162012656935895e-02 -9.139945093572596e-02 -9.117886729658348e-02 -9.095837571294788e-02 + -9.073797605928635e-02 -9.051766837713708e-02 -9.029745274779008e-02 -9.007732920697027e-02 -8.985729759887780e-02 + -8.963735802530043e-02 -8.941751083887589e-02 -8.919775594907166e-02 -8.897809325953572e-02 -8.875852286193828e-02 + -8.853904483959285e-02 -8.831965916578795e-02 -8.810036569419880e-02 -8.788116467295366e-02 -8.766205635082600e-02 + -8.744304058057480e-02 -8.722411733824492e-02 -8.700528670561582e-02 -8.678654875532379e-02 -8.656790339361393e-02 + -8.634935054757228e-02 -8.613089058374623e-02 -8.591252359970507e-02 -8.569424942256174e-02 -8.547606809595372e-02 + -8.525797972327777e-02 -8.503998436304407e-02 -8.482208183975883e-02 -8.460427219735964e-02 -8.438655581333676e-02 + -8.416893266387415e-02 -8.395140264416648e-02 -8.373396580036768e-02 -8.351662221748458e-02 -8.329937190808817e-02 + -8.308221474187347e-02 -8.286515089972675e-02 -8.264818063381729e-02 -8.243130387381740e-02 -8.221452057360500e-02 + -8.199783077068876e-02 -8.178123458056528e-02 -8.156473193866548e-02 -8.134832272179610e-02 -8.113200727104515e-02 + -8.091578573554094e-02 -8.069965795549490e-02 -8.048362394306618e-02 -8.026768379237301e-02 -8.005183759034226e-02 + -7.983608519016389e-02 -7.962042660317335e-02 -7.940486220827629e-02 -7.918939199917317e-02 -7.897401585103307e-02 + -7.875873382193239e-02 -7.854354599947752e-02 -7.832845240531904e-02 -7.811345290511561e-02 -7.789854765910142e-02 + -7.768373695009409e-02 -7.746902070156129e-02 -7.725439886068521e-02 -7.703987147751143e-02 -7.682543865920169e-02 + -7.661110037032860e-02 -7.639685648697914e-02 -7.618270730319152e-02 -7.596865299784139e-02 -7.575469343456721e-02 + -7.554082861289950e-02 -7.532705861915691e-02 -7.511338355056779e-02 -7.489980327273796e-02 -7.468631776375068e-02 + -7.447292742489155e-02 -7.425963225373161e-02 -7.404643208981297e-02 -7.383332706618533e-02 -7.362031725942129e-02 + -7.340740264369265e-02 -7.319458312424655e-02 -7.298185885257603e-02 -7.276923011698885e-02 -7.255669681825400e-02 + -7.234425890125808e-02 -7.213191646645117e-02 -7.191966959969415e-02 -7.170751827394115e-02 -7.149546237742448e-02 + -7.128350216363183e-02 -7.107163782537941e-02 -7.085986923051370e-02 -7.064819639413342e-02 -7.043661941815849e-02 + -7.022513838389523e-02 -7.001375316964638e-02 -6.980246372359999e-02 -6.959127044971054e-02 -6.938017339783993e-02 + -6.916917238807876e-02 -6.895826751099868e-02 -6.874745887832359e-02 -6.853674652264935e-02 -6.832613029387129e-02 + -6.811561029537151e-02 -6.790518687416305e-02 -6.769485994872884e-02 -6.748462944761908e-02 -6.727449549181348e-02 + -6.706445814195625e-02 -6.685451736224034e-02 -6.664467305023641e-02 -6.643492546019260e-02 -6.622527482862205e-02 + -6.601572100856345e-02 -6.580626400049541e-02 -6.559690390732385e-02 -6.538764078471235e-02 -6.517847455920224e-02 + -6.496940519404462e-02 -6.476043303620643e-02 -6.455155816426872e-02 -6.434278041275177e-02 -6.413409988235154e-02 + -6.392551667227454e-02 -6.371703078482928e-02 -6.350864213121965e-02 -6.330035079826633e-02 -6.309215709125325e-02 + -6.288406097171770e-02 -6.267606236590158e-02 -6.246816137578116e-02 -6.226035810132791e-02 -6.205265253482506e-02 + -6.184504450634240e-02 -6.163753424009603e-02 -6.143012204113525e-02 -6.122280779495761e-02 -6.101559145710207e-02 + -6.080847310111580e-02 -6.060145284620669e-02 -6.039453063876327e-02 -6.018770637541451e-02 -5.998098039534337e-02 + -5.977435284136760e-02 -5.956782355675167e-02 -5.936139258218223e-02 -5.915506002510895e-02 -5.894882595975996e-02 + -5.874269025717062e-02 -5.853665294379332e-02 -5.833071438748900e-02 -5.812487459491447e-02 -5.791913345983549e-02 + -5.771349104248068e-02 -5.750794745476003e-02 -5.730250273990040e-02 -5.709715674449271e-02 -5.689190963313420e-02 + -5.668676170442684e-02 -5.648171287301057e-02 -5.627676311138611e-02 -5.607191251359627e-02 -5.586716116856662e-02 + -5.566250902085241e-02 -5.545795595276776e-02 -5.525350230977423e-02 -5.504914828197500e-02 -5.484489368806074e-02 + -5.464073856561743e-02 -5.443668303623681e-02 -5.423272717677420e-02 -5.402887087270093e-02 -5.382511411736842e-02 + -5.362145727556954e-02 -5.341790037997223e-02 -5.321444331788154e-02 -5.301108618236487e-02 -5.280782907094528e-02 + -5.260467200594416e-02 -5.240161485390568e-02 -5.219865776343095e-02 -5.199580105954085e-02 -5.179304465507040e-02 + -5.159038850941820e-02 -5.138783273765680e-02 -5.118537740030552e-02 -5.098302246878324e-02 -5.078076787428482e-02 + -5.057861387937131e-02 -5.037656068404879e-02 -5.017460818262723e-02 -4.997275637519877e-02 -4.977100534878579e-02 + -4.956935521374012e-02 -4.936780587637167e-02 -4.916635729330274e-02 -4.896500983679772e-02 -4.876376358063662e-02 + -4.856261839799727e-02 -4.836157437280066e-02 -4.816063160553166e-02 -4.795979012910388e-02 -4.775904981223175e-02 + -4.755841077230219e-02 -4.735787336181510e-02 -4.715743752596301e-02 -4.695710319390285e-02 -4.675687045398216e-02 + -4.655673941737810e-02 -4.635671009364274e-02 -4.615678236145827e-02 -4.595695644691457e-02 -4.575723258610617e-02 + -4.555761069075770e-02 -4.535809077212207e-02 -4.515867291944397e-02 -4.495935719937229e-02 -4.476014355843901e-02 + -4.456103197632578e-02 -4.436202279051898e-02 -4.416311608901573e-02 -4.396431172960501e-02 -4.376560979706327e-02 + -4.356701040970479e-02 -4.336851362154585e-02 -4.317011930970618e-02 -4.297182755295056e-02 -4.277363871130811e-02 + -4.257555275870079e-02 -4.237756961321195e-02 -4.217968936488893e-02 -4.198191211978222e-02 -4.178423789759614e-02 + -4.158666657665847e-02 -4.138919837391426e-02 -4.119183356383482e-02 -4.099457203865310e-02 -4.079741379048268e-02 + -4.060035892668235e-02 -4.040340754077800e-02 -4.020655958670875e-02 -4.000981499812348e-02 -3.981317410229721e-02 + -3.961663704352115e-02 -3.942020369405195e-02 -3.922387410519079e-02 -3.902764838570288e-02 -3.883152661169272e-02 + -3.863550868276464e-02 -3.843959464464100e-02 -3.824378485096525e-02 -3.804807931112070e-02 -3.785247793879744e-02 + -3.765698082240899e-02 -3.746158806803077e-02 -3.726629970906549e-02 -3.707111562537097e-02 -3.687603600301111e-02 + -3.668106114329449e-02 -3.648619095542227e-02 -3.629142541706046e-02 -3.609676463615045e-02 -3.590220871216067e-02 + -3.570775761915167e-02 -3.551341127587861e-02 -3.531916998478909e-02 -3.512503392646860e-02 -3.493100298239093e-02 + -3.473707719308593e-02 -3.454325666569649e-02 -3.434954148093054e-02 -3.415593156072503e-02 -3.396242692622412e-02 + -3.376902792182854e-02 -3.357573459185429e-02 -3.338254684613227e-02 -3.318946476737597e-02 -3.299648846264201e-02 + -3.280361798076661e-02 -3.261085320981364e-02 -3.241819429994710e-02 -3.222564156785773e-02 -3.203319495411584e-02 + -3.184085442350271e-02 -3.164862007407277e-02 -3.145649201602077e-02 -3.126447024597763e-02 -3.107255466700169e-02 + -3.088074555671056e-02 -3.068904313085425e-02 -3.049744727803826e-02 -3.030595802638682e-02 -3.011457548570120e-02 + -2.992329974875160e-02 -2.973213075050443e-02 -2.954106848293515e-02 -2.935011329195715e-02 -2.915926525661732e-02 + -2.896852427673346e-02 -2.877789042941862e-02 -2.858736382466336e-02 -2.839694452567641e-02 -2.820663243092813e-02 + -2.801642765839682e-02 -2.782633053619610e-02 -2.763634102981755e-02 -2.744645909471058e-02 -2.725668483048721e-02 + -2.706701834793413e-02 -2.687745966148872e-02 -2.668800867127078e-02 -2.649866562411629e-02 -2.630943076513501e-02 + -2.612030399888650e-02 -2.593128533989631e-02 -2.574237489560391e-02 -2.555357276907920e-02 -2.536487891525730e-02 + -2.517629330290238e-02 -2.498781626631630e-02 -2.479944791947400e-02 -2.461118815951395e-02 -2.442303705775731e-02 + -2.423499472682666e-02 -2.404706124098910e-02 -2.385923651050157e-02 -2.367152062237768e-02 -2.348391391197065e-02 + -2.329641637680258e-02 -2.310902796361102e-02 -2.292174876507744e-02 -2.273457889435020e-02 -2.254751838574287e-02 + -2.236056713942959e-02 -2.217372537079298e-02 -2.198699334983061e-02 -2.180037099746794e-02 -2.161385831877313e-02 + -2.142745542221016e-02 -2.124116241611923e-02 -2.105497927356034e-02 -2.086890594375282e-02 -2.068294274565517e-02 + -2.049708982965088e-02 -2.031134709508492e-02 -2.012571460207244e-02 -1.994019246558534e-02 -1.975478077426674e-02 + -1.956947944878238e-02 -1.938428854559868e-02 -1.919920840769478e-02 -1.901423906121075e-02 -1.882938044349050e-02 + -1.864463264867233e-02 -1.845999578941159e-02 -1.827546991282947e-02 -1.809105492490821e-02 -1.790675101318496e-02 + -1.772255847013706e-02 -1.753847723077995e-02 -1.735450728912205e-02 -1.717064875577919e-02 -1.698690174123156e-02 + -1.680326624034783e-02 -1.661974219495428e-02 -1.643632989539235e-02 -1.625302952284425e-02 -1.606984099009794e-02 + -1.588676434582367e-02 -1.570379970237604e-02 -1.552094715767664e-02 -1.533820665109939e-02 -1.515557821470722e-02 + -1.497306218983010e-02 -1.479065863118324e-02 -1.460836746737021e-02 -1.442618879376636e-02 -1.424412272699600e-02 + -1.406216932715821e-02 -1.388032850365394e-02 -1.369860041414062e-02 -1.351698537084881e-02 -1.333548332713773e-02 + -1.315409426742165e-02 -1.297281830737383e-02 -1.279165555870565e-02 -1.261060603011550e-02 -1.242966965324022e-02 + -1.224884670128487e-02 -1.206813738892206e-02 -1.188754163203305e-02 -1.170705946859269e-02 -1.152669101347058e-02 + -1.134643637569507e-02 -1.116629550991553e-02 -1.098626842139487e-02 -1.080635544822676e-02 -1.062655668128806e-02 + -1.044687204494093e-02 -1.026730162280993e-02 -1.008784553433474e-02 -9.908503858526582e-03 -9.729276511698201e-03 + -9.550163618928804e-03 -9.371165505355611e-03 -9.192282154920128e-03 -9.013513542246960e-03 -8.834859775588668e-03 + -8.656320970291077e-03 -8.477897155130903e-03 -8.299588259899083e-03 -8.121394531144674e-03 -7.943316209259341e-03 + -7.765353219198069e-03 -7.587505591333328e-03 -7.409773443860054e-03 -7.232156891183837e-03 -7.054655906230881e-03 + -6.877270474033493e-03 -6.700000921715352e-03 -6.522847372218281e-03 -6.345809748257097e-03 -6.168888131399519e-03 + -5.992082642122597e-03 -5.815393366379400e-03 -5.638820235869921e-03 -5.462363348533388e-03 -5.286023033805962e-03 + -5.109799304673499e-03 -4.933692127821829e-03 -4.757701606393674e-03 -4.581827861470766e-03 -4.406070940931505e-03 + -4.230430770274698e-03 -4.054907567997104e-03 -3.879501600335772e-03 -3.704212807069328e-03 -3.529041210474627e-03 + -3.353986930090703e-03 -3.179050081041732e-03 -3.004230655593028e-03 -2.829528626659512e-03 -2.654944304289923e-03 + -2.480477843039907e-03 -2.306129168890747e-03 -2.131898354626704e-03 -1.957785522367332e-03 -1.783790769612464e-03 + -1.609914041309663e-03 -1.436155409326836e-03 -1.262515208025358e-03 -1.088993476198761e-03 -9.155901719868249e-04 + -7.423054008843995e-04 -5.691392854771952e-04 -3.960918865957833e-04 -2.231631331613931e-04 -5.035321608514060e-05 + 1.223375771945329e-04 2.949092895407656e-04 4.673619084872533e-04 6.396953140537370e-04 8.119093865188150e-04 + 9.840041155727759e-04 1.155979539871523e-03 1.327835367602612e-03 1.499571413663267e-03 1.671187748049661e-03 + 1.842684305331169e-03 2.014060960896812e-03 2.185317608856639e-03 2.356454289147141e-03 2.527470954200780e-03 + 2.698367270832486e-03 2.869143169831049e-03 3.039798698561594e-03 3.210333755176400e-03 3.380748214685887e-03 + 3.551042001872539e-03 3.721215182132198e-03 3.891267592694254e-03 4.061198929412137e-03 4.231009214636464e-03 + 4.400698444839332e-03 4.570266499650065e-03 4.739713256426893e-03 4.909038688279234e-03 5.078242841339914e-03 + 5.247325443294046e-03 5.416286280121805e-03 5.585125417934797e-03 5.753842797319914e-03 5.922438289361948e-03 + 6.090911784292105e-03 6.259263304936011e-03 6.427492823105761e-03 6.595600012759487e-03 6.763584774419725e-03 + 6.931447157908777e-03 7.099187064683324e-03 7.266804368739545e-03 7.434298984071849e-03 7.601670964899477e-03 + 7.768920175905106e-03 7.936046303989365e-03 8.103049345026314e-03 8.269929303195386e-03 8.436686062480435e-03 + 8.603319496825714e-03 8.769829559891583e-03 8.936216298209541e-03 9.102479469308070e-03 9.268618835503980e-03 + 9.434634442417017e-03 9.600526244002849e-03 9.766294116521254e-03 9.931937936947469e-03 1.009745771049027e-02 + 1.026285342997890e-02 1.042812477681206e-02 1.059327162144324e-02 1.075829401681754e-02 1.092319186819127e-02 + 1.108796504594824e-02 1.125261345370748e-02 1.141713713772357e-02 1.158153598704318e-02 1.174580967555363e-02 + 1.190995817803677e-02 1.207398151021485e-02 1.223787955540131e-02 1.240165218070774e-02 1.256529932365555e-02 + 1.272882103806231e-02 1.289221710280211e-02 1.305548725320952e-02 1.321863152957668e-02 1.338164989105289e-02 + 1.354454220587777e-02 1.370730835288826e-02 1.386994832163190e-02 1.403246211588375e-02 1.419484943187744e-02 + 1.435711010999991e-02 1.451924419921884e-02 1.468125161270911e-02 1.484313222013652e-02 1.500488591571896e-02 + 1.516651273046586e-02 1.532801257754355e-02 1.548938513124086e-02 1.565063033579857e-02 1.581174821092933e-02 + 1.597273864701365e-02 1.613360150922888e-02 1.629433671764488e-02 1.645494432276120e-02 1.661542413184349e-02 + 1.677577586209575e-02 1.693599953321696e-02 1.709609511287956e-02 1.725606247097126e-02 1.741590148147653e-02 + 1.757561211738663e-02 1.773519439308624e-02 1.789464801957598e-02 1.805397280960725e-02 1.821316881163111e-02 + 1.837223594327105e-02 1.853117406905512e-02 1.868998307594014e-02 1.884866298214414e-02 1.900721372338833e-02 + 1.916563497459167e-02 1.932392665507269e-02 1.948208878919649e-02 1.964012126059438e-02 1.979802393750615e-02 + 1.995579673545799e-02 2.011343968946751e-02 2.027095263124555e-02 2.042833526879373e-02 2.058558759933038e-02 + 2.074270959919291e-02 2.089970114286997e-02 2.105656209513535e-02 2.121329241031374e-02 2.136989211400533e-02 + 2.152636093833320e-02 2.168269866776463e-02 2.183890534086288e-02 2.199498088647827e-02 2.215092516911965e-02 + 2.230673806408907e-02 2.246241957468516e-02 2.261796965793072e-02 2.277338799181243e-02 2.292867446749406e-02 + 2.308382911412376e-02 2.323885181888266e-02 2.339374244699652e-02 2.354850090287507e-02 2.370312721409915e-02 + 2.385762123470989e-02 2.401198266010886e-02 2.416621147301771e-02 2.432030765671687e-02 2.447427107682733e-02 + 2.462810160176357e-02 2.478179917471193e-02 2.493536381795363e-02 2.508879528739230e-02 2.524209334527653e-02 + 2.539525801488748e-02 2.554828923354157e-02 2.570118686847216e-02 2.585395079171064e-02 2.600658098606827e-02 + 2.615907742012537e-02 2.631143978762620e-02 2.646366795301069e-02 2.661576194257877e-02 2.676772164859378e-02 + 2.691954693391293e-02 2.707123769272043e-02 2.722279394328245e-02 2.737421556407061e-02 2.752550224474631e-02 + 2.767665393933695e-02 2.782767063812680e-02 2.797855221700411e-02 2.812929853552858e-02 2.827990951702357e-02 + 2.843038519104858e-02 2.858072533585580e-02 2.873092969062032e-02 2.888099827101270e-02 2.903093101911967e-02 + 2.918072779556083e-02 2.933038847140823e-02 2.947991301658642e-02 2.962930141213865e-02 2.977855336278226e-02 + 2.992766870509821e-02 3.007664746318324e-02 3.022548953626840e-02 3.037419478553557e-02 3.052276309616091e-02 + 3.067119447416764e-02 3.081948881896879e-02 3.096764581778017e-02 3.111566540198458e-02 3.126354756710210e-02 + 3.141129218718559e-02 3.155889912410548e-02 3.170636829125183e-02 3.185369970791438e-02 3.200089317518744e-02 + 3.214794841776677e-02 3.229486543634106e-02 3.244164418203412e-02 3.258828451581320e-02 3.273478630264194e-02 + 3.288114949586567e-02 3.302737408530167e-02 3.317345979235018e-02 3.331940642975919e-02 3.346521401820098e-02 + 3.361088246101045e-02 3.375641161607764e-02 3.390180136352038e-02 3.404705169548587e-02 3.419216253016829e-02 + 3.433713355905806e-02 3.448196468652563e-02 3.462665590981111e-02 3.477120710939272e-02 3.491561814527116e-02 + 3.505988891618091e-02 3.520401943397326e-02 3.534800952666442e-02 3.549185891051008e-02 3.563556756111654e-02 + 3.577913543618631e-02 3.592256240340591e-02 3.606584831947614e-02 3.620899312153205e-02 3.635199681091714e-02 + 3.649485912620978e-02 3.663757985375464e-02 3.678015900636063e-02 3.692259649832257e-02 3.706489218607827e-02 + 3.720704593508108e-02 3.734905772908955e-02 3.749092751022131e-02 3.763265496742431e-02 3.777423997951684e-02 + 3.791568254953915e-02 3.805698256030369e-02 3.819813986869797e-02 3.833915436267914e-02 3.848002605018682e-02 + 3.862075477984065e-02 3.876134025391093e-02 3.890178243600422e-02 3.904208129158644e-02 3.918223668100989e-02 + 3.932224846044379e-02 3.946211655605483e-02 3.960184097189857e-02 3.974142146457355e-02 3.988085779819951e-02 + 4.002014997942075e-02 4.015929792921669e-02 4.029830150192959e-02 4.043716055991190e-02 4.057587507004282e-02 + 4.071444498657769e-02 4.085287001066611e-02 4.099114999824743e-02 4.112928495212512e-02 4.126727475679569e-02 + 4.140511926665246e-02 4.154281836167219e-02 4.168037204269245e-02 4.181778018003033e-02 4.195504246778908e-02 + 4.209215884913708e-02 4.222912929605258e-02 4.236595366776428e-02 4.250263182248033e-02 4.263916367566677e-02 + 4.277554922465009e-02 4.291178824859961e-02 4.304788049654025e-02 4.318382596138427e-02 4.331962457087349e-02 + 4.345527617981602e-02 4.359078064797250e-02 4.372613792550029e-02 4.386134797486977e-02 4.399641051415262e-02 + 4.413132537776133e-02 4.426609256403441e-02 4.440071196061698e-02 4.453518342174363e-02 4.466950682320869e-02 + 4.480368214879805e-02 4.493770928728694e-02 4.507158793990715e-02 4.520531802497359e-02 4.533889951667943e-02 + 4.547233228082954e-02 4.560561616979211e-02 4.573875108353129e-02 4.587173702317195e-02 4.600457379177124e-02 + 4.613726112101928e-02 4.626979898466685e-02 4.640218731770854e-02 4.653442597807410e-02 4.666651481740990e-02 + 4.679845378497393e-02 4.693024287357150e-02 4.706188178521280e-02 4.719337030512012e-02 4.732470843170088e-02 + 4.745589609974604e-02 4.758693317708736e-02 4.771781949014568e-02 4.784855500276729e-02 4.797913963655120e-02 + 4.810957311625792e-02 4.823985532440599e-02 4.836998622519359e-02 4.849996572088229e-02 4.862979364778694e-02 + 4.875946986129576e-02 4.888899438454671e-02 4.901836703838853e-02 4.914758752328308e-02 4.927665585368439e-02 + 4.940557196434897e-02 4.953433564666962e-02 4.966294680168561e-02 4.979140536998770e-02 4.991971127467005e-02 + 5.004786430086550e-02 5.017586426593462e-02 5.030371111424699e-02 5.043140473941395e-02 5.055894500969876e-02 + 5.068633180855401e-02 5.081356509387767e-02 5.094064477169723e-02 5.106757053524139e-02 5.119434226596677e-02 + 5.132095996453229e-02 5.144742351517578e-02 5.157373274644007e-02 5.169988750799723e-02 5.182588783131492e-02 + 5.195173357105356e-02 5.207742440366903e-02 5.220296027189056e-02 5.232834113948501e-02 5.245356688434039e-02 + 5.257863735375337e-02 5.270355244318054e-02 5.282831211610928e-02 5.295291615700908e-02 5.307736435753736e-02 + 5.320165668494783e-02 5.332579302368824e-02 5.344977322479061e-02 5.357359720391287e-02 5.369726488407797e-02 + 5.382077614890905e-02 5.394413077320572e-02 5.406732861255047e-02 5.419036960275756e-02 5.431325364836510e-02 + 5.443598061485443e-02 5.455855035736775e-02 5.468096283548277e-02 5.480321791614200e-02 5.492531533836561e-02 + 5.504725504027442e-02 5.516903696522249e-02 5.529066094250196e-02 5.541212681912044e-02 5.553343451105355e-02 + 5.565458402054679e-02 5.577557512714444e-02 5.589640757833542e-02 5.601708136214176e-02 5.613759637012277e-02 + 5.625795242697428e-02 5.637814944133901e-02 5.649818735356010e-02 5.661806606948155e-02 5.673778531909066e-02 + 5.685734496106067e-02 5.697674499811992e-02 5.709598525886500e-02 5.721506557962035e-02 5.733398588420521e-02 + 5.745274613557275e-02 5.757134619305772e-02 5.768978576165893e-02 5.780806477237931e-02 5.792618319490116e-02 + 5.804414085654030e-02 5.816193759992416e-02 5.827957333255503e-02 5.839704805764100e-02 5.851436157058919e-02 + 5.863151359019340e-02 5.874850407742044e-02 5.886533297606138e-02 5.898200016057164e-02 5.909850545490182e-02 + 5.921484876799358e-02 5.933103006596772e-02 5.944704910278828e-02 5.956290569090495e-02 5.967859979076014e-02 + 5.979413129454921e-02 5.990950006107775e-02 6.002470595625681e-02 6.013974894676900e-02 6.025462892974234e-02 + 6.036934559538653e-02 6.048389882575328e-02 6.059828859366181e-02 6.071251478747773e-02 6.082657726499330e-02 + 6.094047589468096e-02 6.105421060960093e-02 6.116778124880510e-02 6.128118760026364e-02 6.139442960439424e-02 + 6.150750715787331e-02 6.162042008748835e-02 6.173316829355946e-02 6.184575170612789e-02 6.195817023946892e-02 + 6.207042366308074e-02 6.218251178412997e-02 6.229443455021107e-02 6.240619187345142e-02 6.251778362644587e-02 + 6.262920965673664e-02 6.274046989094115e-02 6.285156423838029e-02 6.296249246083868e-02 6.307325441937692e-02 + 6.318385004239983e-02 6.329427920287174e-02 6.340454177652059e-02 6.351463766120390e-02 6.362456678994362e-02 + 6.373432899407734e-02 6.384392402667542e-02 6.395335181995393e-02 6.406261231361865e-02 6.417170537725830e-02 + 6.428063082883417e-02 6.438938856382127e-02 6.449797859582693e-02 6.460640069400744e-02 6.471465460887021e-02 + 6.482274028565467e-02 6.493065766530991e-02 6.503840663024645e-02 6.514598697176463e-02 6.525339863731919e-02 + 6.536064160053869e-02 6.546771556229376e-02 6.557462036169828e-02 6.568135597564134e-02 6.578792228094754e-02 + 6.589431913461476e-02 6.600054641494822e-02 6.610660407274732e-02 6.621249195669229e-02 6.631820979208959e-02 + 6.642375751800587e-02 6.652913508526218e-02 6.663434233390064e-02 6.673937912206085e-02 6.684424535139094e-02 + 6.694894096694531e-02 6.705346576057515e-02 6.715781952052316e-02 6.726200223606826e-02 6.736601378290344e-02 + 6.746985396850236e-02 6.757352270136854e-02 6.767701992273348e-02 6.778034554033589e-02 6.788349929667206e-02 + 6.798648102682574e-02 6.808929069330329e-02 6.819192820375723e-02 6.829439341428477e-02 6.839668615716293e-02 + 6.849880637697058e-02 6.860075397106770e-02 6.870252870886938e-02 6.880413046413429e-02 6.890555915577500e-02 + 6.900681468090485e-02 6.910789689150486e-02 6.920880565820778e-02 6.930954094436353e-02 6.941010257623929e-02 + 6.951049032497619e-02 6.961070411466443e-02 6.971074386483528e-02 6.981060945693285e-02 6.991030074013053e-02 + 7.000981760721879e-02 7.010915998226322e-02 7.020832768385020e-02 7.030732053981503e-02 7.040613843777971e-02 + 7.050478130476578e-02 7.060324902125202e-02 7.070154139632766e-02 7.079965841104072e-02 7.089759998592053e-02 + 7.099536579014293e-02 7.109295574922263e-02 7.119036986301433e-02 7.128760792254588e-02 7.138466979343019e-02 + 7.148155540894172e-02 7.157826467726322e-02 7.167479742578257e-02 7.177115345207208e-02 7.186733268619028e-02 + 7.196333504975572e-02 7.205916041090092e-02 7.215480858692887e-02 7.225027948023270e-02 7.234557308374470e-02 + 7.244068916926014e-02 7.253562753252076e-02 7.263038813284139e-02 7.272497087062332e-02 7.281937559790036e-02 + 7.291360215228662e-02 7.300765049821943e-02 7.310152057265214e-02 7.319521208383468e-02 7.328872490709243e-02 + 7.338205901635925e-02 7.347521425841259e-02 7.356819049091311e-02 7.366098761637971e-02 7.375360558736099e-02 + 7.384604424623381e-02 7.393830334347133e-02 7.403038279875497e-02 7.412228254437477e-02 7.421400245985316e-02 + 7.430554241104276e-02 7.439690229021774e-02 7.448808202204141e-02 7.457908141717452e-02 7.466990029970315e-02 + 7.476053861745356e-02 7.485099625058683e-02 7.494127304678436e-02 7.503136889191833e-02 7.512128371784581e-02 + 7.521101743547498e-02 7.530056981436373e-02 7.538994071268737e-02 7.547913007544443e-02 7.556813780083994e-02 + 7.565696374971752e-02 7.574560777501017e-02 7.583406981695588e-02 7.592234975180168e-02 7.601044736291800e-02 + 7.609836256769248e-02 7.618609528331391e-02 7.627364535037680e-02 7.636101265407126e-02 7.644819711937149e-02 + 7.653519868718589e-02 7.662201715447789e-02 7.670865230880411e-02 7.679510411035856e-02 7.688137246970578e-02 + 7.696745724207896e-02 7.705335828035317e-02 7.713907552614908e-02 7.722460893765626e-02 7.730995825366380e-02 + 7.739512330293280e-02 7.748010405365591e-02 7.756490042829636e-02 7.764951228919105e-02 7.773393946198498e-02 + 7.781818189157449e-02 7.790223948237281e-02 7.798611201876808e-02 7.806979939436651e-02 7.815330154059554e-02 + 7.823661834982702e-02 7.831974966729814e-02 7.840269536418043e-02 7.848545542109749e-02 7.856802968700778e-02 + 7.865041794492959e-02 7.873262009221961e-02 7.881463606524114e-02 7.889646578364969e-02 7.897810905385311e-02 + 7.905956578813299e-02 7.914083598393755e-02 7.922191938944982e-02 7.930281582198326e-02 7.938352526916173e-02 + 7.946404763288464e-02 7.954438277705837e-02 7.962453057021987e-02 7.970449093695484e-02 7.978426377009373e-02 + 7.986384886265184e-02 7.994324611178145e-02 8.002245546069972e-02 8.010147680163558e-02 8.018030998339011e-02 + 8.025895486859348e-02 8.033741142939121e-02 8.041567953647351e-02 8.049375898816008e-02 8.057164970191152e-02 + 8.064935159117341e-02 8.072686453538828e-02 8.080418841559016e-02 8.088132313650849e-02 8.095826861741187e-02 + 8.103502469212946e-02 8.111159121525567e-02 8.118796811657426e-02 8.126415526945288e-02 8.134015254787534e-02 + 8.141595988122388e-02 8.149157718184835e-02 8.156700432424771e-02 8.164224113093393e-02 8.171728750211138e-02 + 8.179214337283539e-02 8.186680860558979e-02 8.194128308109257e-02 8.201556671181809e-02 8.208965942384167e-02 + 8.216356107347705e-02 8.223727146913333e-02 8.231079055026533e-02 8.238411825286719e-02 8.245725445426123e-02 + 8.253019901019013e-02 8.260295182089074e-02 8.267551284923887e-02 8.274788192985057e-02 8.282005889192648e-02 + 8.289204367192234e-02 8.296383619751495e-02 8.303543635380874e-02 8.310684396376640e-02 8.317805898151856e-02 + 8.324908138250064e-02 8.331991092178788e-02 8.339054746670159e-02 8.346099098907200e-02 8.353124136246602e-02 + 8.360129848004999e-02 8.367116227251760e-02 8.374083263302687e-02 8.381030943134427e-02 8.387959252741883e-02 + 8.394868181167527e-02 8.401757720093640e-02 8.408627862550171e-02 8.415478594369409e-02 8.422309904154775e-02 + 8.429121790707177e-02 8.435914237533512e-02 8.442687225429805e-02 8.449440750560887e-02 8.456174803803686e-02 + 8.462889372267089e-02 8.469584447602406e-02 8.476260023136410e-02 8.482916090148240e-02 8.489552630009754e-02 + 8.496169630228255e-02 8.502767086164854e-02 8.509344988672647e-02 8.515903326018803e-02 8.522442086136313e-02 + 8.528961263471936e-02 8.535460848680074e-02 8.541940824041729e-02 8.548401181612168e-02 8.554841915131453e-02 + 8.561263012321893e-02 8.567664461211427e-02 8.574046253447680e-02 8.580408386832587e-02 8.586750845589863e-02 + 8.593073610333024e-02 8.599376680387132e-02 8.605660047760594e-02 8.611923696874126e-02 8.618167618396408e-02 + 8.624391807608472e-02 8.630596259724549e-02 8.636780954833972e-02 8.642945878839840e-02 8.649091029427977e-02 + 8.655216396695875e-02 8.661321970043215e-02 8.667407742210617e-02 8.673473702989365e-02 8.679519841504303e-02 + 8.685546148336530e-02 8.691552612855238e-02 8.697539224666265e-02 8.703505975750943e-02 8.709452857692032e-02 + 8.715379861893667e-02 8.721286980508075e-02 8.727174201224434e-02 8.733041510377958e-02 8.738888903629666e-02 + 8.744716372671989e-02 8.750523904187274e-02 8.756311491392924e-02 8.762079127795709e-02 8.767826803995526e-02 + 8.773554506310657e-02 8.779262223690780e-02 8.784949951260017e-02 8.790617682173207e-02 8.796265406226209e-02 + 8.801893109931651e-02 8.807500788687952e-02 8.813088437660771e-02 8.818656039674132e-02 8.824203585227545e-02 + 8.829731070095961e-02 8.835238486000704e-02 8.840725822106667e-02 8.846193068214857e-02 8.851640221803356e-02 + 8.857067273700293e-02 8.862474207580676e-02 8.867861014722141e-02 8.873227689758616e-02 8.878574227696898e-02 + 8.883900618220902e-02 8.889206851560667e-02 8.894492921167085e-02 8.899758815302622e-02 8.905004524008538e-02 + 8.910230044719054e-02 8.915435367300073e-02 8.920620479173334e-02 8.925785373448247e-02 8.930930045917142e-02 + 8.936054490961548e-02 8.941158695191696e-02 8.946242647641844e-02 8.951306341364354e-02 8.956349771969928e-02 + 8.961372931388180e-02 8.966375808278661e-02 8.971358396554302e-02 8.976320688963368e-02 8.981262675341668e-02 + 8.986184348935064e-02 8.991085703129179e-02 8.995966729258320e-02 9.000827417122792e-02 9.005667759770250e-02 + 9.010487756379584e-02 9.015287394264000e-02 9.020066659275561e-02 9.024825550203337e-02 9.029564061179933e-02 + 9.034282181894199e-02 9.038979902630290e-02 9.043657218570805e-02 9.048314126656666e-02 9.052950615463343e-02 + 9.057566675480395e-02 9.062162300961238e-02 9.066737484935303e-02 9.071292219781772e-02 9.075826498061153e-02 + 9.080340315127385e-02 9.084833664156222e-02 9.089306533771581e-02 9.093758915627431e-02 9.098190804149961e-02 + 9.102602195783284e-02 9.106993084471440e-02 9.111363462196023e-02 9.115713320054021e-02 9.120042650346059e-02 + 9.124351446434358e-02 9.128639702175202e-02 9.132907412994692e-02 9.137154573427010e-02 9.141381170435277e-02 + 9.145587198962597e-02 9.149772660800266e-02 9.153937542844172e-02 9.158081834977004e-02 9.162205535599281e-02 + 9.166308637778346e-02 9.170391133536025e-02 9.174453017072061e-02 9.178494285856946e-02 9.182514933661440e-02 + 9.186514945794547e-02 9.190494319482566e-02 9.194453054665523e-02 9.198391140758180e-02 9.202308569543158e-02 + 9.206205336702038e-02 9.210081441034919e-02 9.213936875086109e-02 9.217771627651770e-02 9.221585694962209e-02 + 9.225379072840771e-02 9.229151754885842e-02 9.232903734819613e-02 9.236635007909103e-02 9.240345570404732e-02 + 9.244035413434255e-02 9.247704529963750e-02 9.251352918345666e-02 9.254980573968512e-02 9.258587489795035e-02 + 9.262173657649034e-02 9.265739073985793e-02 9.269283735974691e-02 9.272807636276849e-02 9.276310769047050e-02 + 9.279793130272118e-02 9.283254716719631e-02 9.286695521394739e-02 9.290115536246511e-02 9.293514761281572e-02 + 9.296893192325742e-02 9.300250819824006e-02 9.303587638369953e-02 9.306903645092859e-02 9.310198837852499e-02 + 9.313473209662422e-02 9.316726755984403e-02 9.319959477466139e-02 9.323171364631608e-02 9.326362408592948e-02 + 9.329532610133226e-02 9.332681964339190e-02 9.335810464438972e-02 9.338918108249107e-02 9.342004893308628e-02 + 9.345070815580041e-02 9.348115868437977e-02 9.351140046962789e-02 9.354143348306601e-02 9.357125770365762e-02 + 9.360087308621738e-02 9.363027956518245e-02 9.365947710363894e-02 9.368846567300493e-02 9.371724524372237e-02 + 9.374581578300241e-02 9.377417725111503e-02 9.380232960142115e-02 9.383027280206080e-02 9.385800682788301e-02 + 9.388553164914089e-02 9.391284719773688e-02 9.393995342276806e-02 9.396685035781838e-02 9.399353796706621e-02 + 9.402001617537038e-02 9.404628495786660e-02 9.407234429781461e-02 9.409819417117830e-02 9.412383453169183e-02 + 9.414926534580341e-02 9.417448659641373e-02 9.419949825736050e-02 9.422430029380560e-02 9.424889267135104e-02 + 9.427327539998738e-02 9.429744844865905e-02 9.432141171534560e-02 9.434516522540957e-02 9.436870900006604e-02 + 9.439204294634228e-02 9.441516705436934e-02 9.443808133745002e-02 9.446078573953387e-02 9.448328023801857e-02 + 9.450556483411636e-02 9.452763950923013e-02 9.454950421611270e-02 9.457115890701832e-02 9.459260360830167e-02 + 9.461383832574666e-02 9.463486302352626e-02 9.465567765409444e-02 9.467628220109425e-02 9.469667668274938e-02 + 9.471686106967921e-02 9.473683533004949e-02 9.475659945563136e-02 9.477615343325803e-02 9.479549725292793e-02 + 9.481463091432241e-02 9.483355439545672e-02 9.485226766778346e-02 9.487077071788189e-02 9.488906353992572e-02 + 9.490714613644993e-02 9.492501852119042e-02 9.494268066964073e-02 9.496013253895599e-02 9.497737414244060e-02 + 9.499440547543551e-02 9.501122651272445e-02 9.502783728094538e-02 9.504423778187990e-02 9.506042797340242e-02 + 9.507640785191551e-02 9.509217742006319e-02 9.510773667189122e-02 9.512308563868060e-02 9.513822432123879e-02 + 9.515315264231193e-02 9.516787063845662e-02 9.518237836728226e-02 9.519667577724227e-02 9.521076284349063e-02 + 9.522463958294539e-02 9.523830604498588e-02 9.525176221483619e-02 9.526500804718509e-02 9.527804359769618e-02 + 9.529086886623650e-02 9.530348379689602e-02 9.531588845120076e-02 9.532808286166987e-02 9.534006699012688e-02 + 9.535184085361241e-02 9.536340447105748e-02 9.537475783364874e-02 9.538590095359538e-02 9.539683385237334e-02 + 9.540755654711666e-02 9.541806903829181e-02 9.542837132640679e-02 9.543846343230179e-02 9.544834536597921e-02 + 9.545801714100983e-02 9.546747880593646e-02 9.547673036184304e-02 9.548577178084619e-02 9.549460309483834e-02 + 9.550322434581640e-02 9.551163556335956e-02 9.551983673903520e-02 9.552782788036314e-02 9.553560902903191e-02 + 9.554318022933674e-02 9.555054148771730e-02 9.555769276632298e-02 9.556463412975340e-02 9.557136563747151e-02 + 9.557788725689133e-02 9.558419903459103e-02 9.559030102901959e-02 9.559619321427665e-02 9.560187562136102e-02 + 9.560734830883322e-02 9.561261127917654e-02 9.561766456108449e-02 9.562250820572099e-02 9.562714223416331e-02 + 9.563156666435306e-02 9.563578152405575e-02 9.563978686682097e-02 9.564358272631937e-02 9.564716910782914e-02 + 9.565054604965099e-02 9.565371359980702e-02 9.565667179877529e-02 9.565942066526258e-02 9.566196023293236e-02 + 9.566429057683135e-02 9.566641172752892e-02 9.566832368940979e-02 9.567002647518966e-02 9.567152016429874e-02 + 9.567280484915060e-02 9.567388053004788e-02 9.567474721294261e-02 9.567540493730267e-02 9.567585379392737e-02 + 9.567609383300600e-02 9.567612506298810e-02 9.567594754568214e-02 9.567556133790830e-02 9.567496647244744e-02 + 9.567416299512438e-02 9.567315095370396e-02 9.567193039196389e-02 9.567050136232016e-02 9.566886392120964e-02 + 9.566701812558283e-02 9.566496403827787e-02 9.566270170884209e-02 9.566023115264767e-02 9.565755243736668e-02 + 9.565466564791879e-02 9.565157080775241e-02 9.564826797386157e-02 9.564475723264595e-02 9.564103864027859e-02 + 9.563711223757489e-02 9.563297806735498e-02 9.562863621895812e-02 9.562408675116861e-02 9.561932968250994e-02 + 9.561436511583814e-02 9.560919313325968e-02 9.560381374743886e-02 9.559822704785555e-02 9.559243313048145e-02 + 9.558643203289170e-02 9.558022378864620e-02 9.557380846466877e-02 9.556718619530349e-02 9.556035703327785e-02 + 9.555332100122134e-02 9.554607821247386e-02 9.553862873475936e-02 9.553097259908433e-02 9.552310989218279e-02 + 9.551504070130773e-02 9.550676510186747e-02 9.549828317393894e-02 9.548959500356741e-02 9.548070067318166e-02 + 9.547160021295119e-02 9.546229369018946e-02 9.545278124506257e-02 9.544306292579091e-02 9.543313878273989e-02 + 9.542300894892854e-02 9.541267351639289e-02 9.540213254817664e-02 9.539138610562420e-02 9.538043425774057e-02 + 9.536927709152246e-02 9.535791472882026e-02 9.534634726779553e-02 9.533457478138217e-02 9.532259734256758e-02 + 9.531041503990305e-02 9.529802797105680e-02 9.528543620462085e-02 9.527263983869082e-02 9.525963900525855e-02 + 9.524643375927100e-02 9.523302417643500e-02 9.521941040061487e-02 9.520559252291068e-02 9.519157060486365e-02 + 9.517734471153570e-02 9.516291499670615e-02 9.514828160467456e-02 9.513344455080376e-02 9.511840393248631e-02 + 9.510315989360162e-02 9.508771251519674e-02 9.507206189457258e-02 9.505620814925633e-02 9.504015138530268e-02 + 9.502389169582724e-02 9.500742917228551e-02 9.499076394524120e-02 9.497389612890822e-02 9.495682580659018e-02 + 9.493955308203066e-02 9.492207807526097e-02 9.490440091330225e-02 9.488652168366014e-02 9.486844048723730e-02 + 9.485015747906970e-02 9.483167277063544e-02 9.481298644119306e-02 9.479409856622809e-02 9.477500930738031e-02 + 9.475571884085587e-02 9.473622721810367e-02 9.471653454723004e-02 9.469664098786204e-02 9.467654664635866e-02 + 9.465625162221861e-02 9.463575602621152e-02 9.461505999415500e-02 9.459416367044585e-02 9.457306719633034e-02 + 9.455177068421998e-02 9.453027423759350e-02 9.450857796468222e-02 9.448668199276268e-02 9.446458647203468e-02 + 9.444229157255099e-02 9.441979739649474e-02 9.439710403006842e-02 9.437421161454676e-02 9.435112031829759e-02 + 9.432783029179438e-02 9.430434160094567e-02 9.428065438538669e-02 9.425676883924589e-02 9.423268508508292e-02 + 9.420840322981890e-02 9.418392339716981e-02 9.415924578030670e-02 9.413437051700123e-02 9.410929767030043e-02 + 9.408402741009517e-02 9.405855992335012e-02 9.403289535840260e-02 9.400703383941893e-02 9.398097549341558e-02 + 9.395472046838550e-02 9.392826889502673e-02 9.390162091553057e-02 9.387477672023849e-02 9.384773645864139e-02 + 9.382050025947151e-02 9.379306828457251e-02 9.376544068778003e-02 9.373761760606118e-02 9.370959916011609e-02 + 9.368138552427184e-02 9.365297690930323e-02 9.362437342817573e-02 9.359557520850639e-02 9.356658243379877e-02 + 9.353739529945312e-02 9.350801394425273e-02 9.347843843855524e-02 9.344866901272440e-02 9.341870589097585e-02 + 9.338854915644307e-02 9.335819897637819e-02 9.332765555734250e-02 9.329691906420928e-02 9.326598960092489e-02 + 9.323486729288316e-02 9.320355242698486e-02 9.317204517635257e-02 9.314034562740874e-02 9.310845398153604e-02 + 9.307637042858882e-02 9.304409511565054e-02 9.301162817412864e-02 9.297896979469056e-02 9.294612022999450e-02 + 9.291307963943660e-02 9.287984815938743e-02 9.284642594887814e-02 9.281281319942865e-02 9.277901009754375e-02 + 9.274501679883909e-02 9.271083349621308e-02 9.267646039527271e-02 9.264189767811302e-02 9.260714551564306e-02 + 9.257220408228978e-02 9.253707357624473e-02 9.250175417101536e-02 9.246624602802385e-02 9.243054935165987e-02 + 9.239466434718238e-02 9.235859120974489e-02 9.232233012999355e-02 9.228588129454922e-02 9.224924488066757e-02 + 9.221242103323031e-02 9.217540995047416e-02 9.213821191347883e-02 9.210082709355732e-02 9.206325564930115e-02 + 9.202549780755387e-02 9.198755374602623e-02 9.194942363528436e-02 9.191110769995278e-02 9.187260614753277e-02 + 9.183391917841241e-02 9.179504701848260e-02 9.175598985687712e-02 9.171674785963810e-02 9.167732123351167e-02 + 9.163771019528422e-02 9.159791495855178e-02 9.155793572040530e-02 9.151777270193290e-02 9.147742614628342e-02 + 9.143689622063791e-02 9.139618310892414e-02 9.135528705455570e-02 9.131420824439858e-02 9.127294688450004e-02 + 9.123150325806001e-02 9.118987755991119e-02 9.114806996063474e-02 9.110608069642255e-02 9.106390998608170e-02 + 9.102155802996120e-02 9.097902503011562e-02 9.093631123402490e-02 9.089341690732793e-02 9.085034224655422e-02 + 9.080708743846595e-02 9.076365269164367e-02 9.072003828369785e-02 9.067624443485320e-02 9.063227129485288e-02 + 9.058811915193726e-02 9.054378827004000e-02 9.049927881221763e-02 9.045459103770109e-02 9.040972520178260e-02 + 9.036468147234690e-02 9.031946007844127e-02 9.027406127956829e-02 9.022848531585773e-02 9.018273243214560e-02 + 9.013680287341128e-02 9.009069686920407e-02 9.004441462623869e-02 8.999795635152021e-02 8.995132231203949e-02 + 8.990451276610797e-02 8.985752795281814e-02 8.981036812557305e-02 8.976303351703613e-02 8.971552434037033e-02 + 8.966784087291869e-02 8.961998334831080e-02 8.957195192338249e-02 8.952374693198487e-02 8.947536869631613e-02 + 8.942681737354224e-02 8.937809319632291e-02 8.932919644498671e-02 8.928012738635183e-02 8.923088623240803e-02 + 8.918147319450437e-02 8.913188858291199e-02 8.908213269254797e-02 8.903220577223506e-02 8.898210800726358e-02 + 8.893183965769864e-02 8.888140104180198e-02 8.883079233855783e-02 8.878001380541380e-02 8.872906581842580e-02 + 8.867794859494142e-02 8.862666233412557e-02 8.857520730323154e-02 8.852358381153494e-02 8.847179212845252e-02 + 8.841983243253916e-02 8.836770502123131e-02 8.831541022882371e-02 8.826294830990469e-02 8.821031949641793e-02 + 8.815752403748606e-02 8.810456224863354e-02 8.805143437639511e-02 8.799814063336710e-02 8.794468134879541e-02 + 8.789105684257616e-02 8.783726738270531e-02 8.778331316928159e-02 8.772919447874153e-02 8.767491167446911e-02 + 8.762046495069514e-02 8.756585454037039e-02 8.751108081839833e-02 8.745614408581825e-02 8.740104459021790e-02 + 8.734578256007368e-02 8.729035830815834e-02 8.723477214343743e-02 8.717902426868683e-02 8.712311501918556e-02 + 8.706704476846663e-02 8.701081371877695e-02 8.695442211628683e-02 8.689787027644420e-02 8.684115853767592e-02 + 8.678428714435096e-02 8.672725629439892e-02 8.667006642064547e-02 8.661271785522098e-02 8.655521075244504e-02 + 8.649754543067346e-02 8.643972223965939e-02 8.638174147222141e-02 8.632360334916610e-02 8.626530814542391e-02 + 8.620685627786050e-02 8.614824804295058e-02 8.608948367410735e-02 8.603056343813603e-02 8.597148768708160e-02 + 8.591225676580187e-02 8.585287085352321e-02 8.579333027004854e-02 8.573363543090719e-02 8.567378659419787e-02 + 8.561378404241062e-02 8.555362810687137e-02 8.549331906471129e-02 8.543285719635127e-02 8.537224281446841e-02 + 8.531147627953188e-02 8.525055791649624e-02 8.518948798167383e-02 8.512826679756995e-02 8.506689470133286e-02 + 8.500537199311337e-02 8.494369892596923e-02 8.488187579804041e-02 8.481990305210670e-02 8.475778099074194e-02 + 8.469550984763315e-02 8.463308996695838e-02 8.457052168539449e-02 8.450780530789033e-02 8.444494110975011e-02 + 8.438192942971584e-02 8.431877065438623e-02 8.425546507059704e-02 8.419201297696736e-02 8.412841471805475e-02 + 8.406467061549007e-02 8.400078097306259e-02 8.393674609180030e-02 8.387256634619757e-02 8.380824209666674e-02 + 8.374377362095807e-02 8.367916122870038e-02 8.361440526888680e-02 8.354950611900661e-02 8.348446403538942e-02 + 8.341927927704872e-02 8.335395233905314e-02 8.328848356223681e-02 8.322287316371958e-02 8.315712149574238e-02 + 8.309122893699929e-02 8.302519583647612e-02 8.295902243510637e-02 8.289270907781640e-02 8.282625623697057e-02 + 8.275966417678003e-02 8.269293318851907e-02 8.262606370095599e-02 8.255905601211083e-02 8.249191039312886e-02 + 8.242462718945633e-02 8.235720681988298e-02 8.228964967784431e-02 8.222195602541869e-02 8.215412621284769e-02 + 8.208616062445039e-02 8.201805954142698e-02 8.194982329150195e-02 8.188145225476894e-02 8.181294680713293e-02 + 8.174430731452863e-02 8.167553412282050e-02 8.160662752890076e-02 8.153758789030935e-02 8.146841562526554e-02 + 8.139911098330359e-02 8.132967428676124e-02 8.126010603531450e-02 8.119040656216225e-02 8.112057615694021e-02 + 8.105061517994502e-02 8.098052402265073e-02 8.091030303880128e-02 8.083995248093376e-02 8.076947276447492e-02 + 8.069886435754116e-02 8.062812754457355e-02 8.055726265736828e-02 8.048627008799529e-02 8.041515020636995e-02 + 8.034390332540668e-02 8.027252974489747e-02 8.020102993492553e-02 8.012940431195667e-02 8.005765317555476e-02 + 7.998577686939379e-02 7.991377577220368e-02 7.984165027334414e-02 7.976940065907111e-02 7.969702727793032e-02 + 7.962453065567111e-02 7.955191112254574e-02 7.947916895239987e-02 7.940630455590227e-02 7.933331833212637e-02 + 7.926021063894960e-02 7.918698178217287e-02 7.911363216326053e-02 7.904016223823181e-02 7.896657235187955e-02 + 7.889286283938438e-02 7.881903406306398e-02 7.874508643443230e-02 7.867102031060058e-02 7.859683599526633e-02 + 7.852253395767629e-02 7.844811463098400e-02 7.837357831424305e-02 7.829892537205134e-02 7.822415619643758e-02 + 7.814927116484589e-02 7.807427062910767e-02 7.799915496813195e-02 7.792392464520610e-02 7.784858004657273e-02 + 7.777312150359181e-02 7.769754936428309e-02 7.762186403791040e-02 7.754606594385612e-02 7.747015537442642e-02 + 7.739413273994507e-02 7.731799855521804e-02 7.724175314852555e-02 7.716539684747571e-02 7.708893004657069e-02 + 7.701235315053030e-02 7.693566653742440e-02 7.685887055661017e-02 7.678196565918903e-02 7.670495227727288e-02 + 7.662783073280909e-02 7.655060142689749e-02 7.647326478202995e-02 7.639582115595660e-02 7.631827089499127e-02 + 7.624061438211467e-02 7.616285210329320e-02 7.608498447266238e-02 7.600701183814436e-02 7.592893457493513e-02 + 7.585075308733022e-02 7.577246778116596e-02 7.569407897223836e-02 7.561558707997214e-02 7.553699264667676e-02 + 7.545829602219666e-02 7.537949752159374e-02 7.530059752746436e-02 7.522159652110559e-02 7.514249491290788e-02 + 7.506329293711217e-02 7.498399108869409e-02 7.490458989985715e-02 7.482508965268882e-02 7.474549074308040e-02 + 7.466579363230305e-02 7.458599868473173e-02 7.450610623924510e-02 7.442611667561436e-02 7.434603053570255e-02 + 7.426584824442337e-02 7.418557009969678e-02 7.410519651333995e-02 7.402472793153594e-02 7.394416477978479e-02 + 7.386350736456949e-02 7.378275607823381e-02 7.370191147772952e-02 7.362097394239986e-02 7.353994380500382e-02 + 7.345882147239775e-02 7.337760740248925e-02 7.329630201371148e-02 7.321490559729334e-02 7.313341861868546e-02 + 7.305184160923943e-02 7.297017492620234e-02 7.288841893034562e-02 7.280657402242413e-02 7.272464064227188e-02 + 7.264261917439505e-02 7.256050997585588e-02 7.247831356170273e-02 7.239603038649280e-02 7.231366079163171e-02 + 7.223120520116612e-02 7.214866404160214e-02 7.206603769517569e-02 7.198332653777370e-02 7.190053098792457e-02 + 7.181765153838118e-02 7.173468863077177e-02 7.165164265282598e-02 7.156851395212357e-02 7.148530298289761e-02 + 7.140201021117390e-02 7.131863593482980e-02 7.123518058493326e-02 7.115164469180060e-02 7.106802866653637e-02 + 7.098433289103630e-02 7.090055775733806e-02 7.081670370962735e-02 7.073277114629017e-02 7.064876042084919e-02 + 7.056467204467058e-02 7.048050649359339e-02 7.039626411522021e-02 7.031194531783586e-02 7.022755055007633e-02 + 7.014308026270048e-02 7.005853477507426e-02 6.997391445865883e-02 6.988921994223606e-02 6.980445161374127e-02 + 6.971960976161336e-02 6.963469490630880e-02 6.954970749457975e-02 6.946464787470261e-02 6.937951638488904e-02 + 6.929431352344900e-02 6.920903988440608e-02 6.912369577614699e-02 6.903828154824053e-02 6.895279768813133e-02 + 6.886724462309453e-02 6.878162274040467e-02 6.869593242264821e-02 6.861017418575431e-02 6.852434851303352e-02 + 6.843845573229547e-02 6.835249626715924e-02 6.826647058722328e-02 6.818037912112360e-02 6.809422221022603e-02 + 6.800800023353686e-02 6.792171381432285e-02 6.783536337902803e-02 6.774894920974223e-02 6.766247176656806e-02 + 6.757593152448671e-02 6.748932891036163e-02 6.740266425451470e-02 6.731593799992638e-02 6.722915072040272e-02 + 6.714230278026269e-02 6.705539454984789e-02 6.696842651283096e-02 6.688139909018249e-02 6.679431266253504e-02 + 6.670716761081900e-02 6.661996446504156e-02 6.653270374249923e-02 6.644538575792285e-02 6.635801090742725e-02 + 6.627057965598744e-02 6.618309245387675e-02 6.609554968705872e-02 6.600795173819872e-02 6.592029914958422e-02 + 6.583259238307172e-02 6.574483179767340e-02 6.565701780669353e-02 6.556915085921187e-02 6.548123140723705e-02 + 6.539325979064996e-02 6.530523643565112e-02 6.521716192687264e-02 6.512903665438342e-02 6.504086097557776e-02 + 6.495263535156262e-02 6.486436022769713e-02 6.477603601048113e-02 6.468766306269763e-02 6.459924187637454e-02 + 6.451077298036002e-02 6.442225675573160e-02 6.433369358016772e-02 6.424508387319842e-02 6.415642813133042e-02 + 6.406772674084167e-02 6.397898002556264e-02 6.389018858464109e-02 6.380135290132970e-02 6.371247325592760e-02 + 6.362355010153516e-02 6.353458392277617e-02 6.344557514446422e-02 6.335652411846264e-02 6.326743126079815e-02 + 6.317829713990436e-02 6.308912216326193e-02 6.299990668862973e-02 6.291065117630994e-02 6.282135608306753e-02 + 6.273202182393535e-02 6.264264873955985e-02 6.255323731562341e-02 6.246378810230178e-02 6.237430143094801e-02 + 6.228477769978175e-02 6.219521740601344e-02 6.210562097707054e-02 6.201598879095212e-02 6.192632121693314e-02 + 6.183661876812600e-02 6.174688193928092e-02 6.165711112558074e-02 6.156730673780070e-02 6.147746920022401e-02 + 6.138759893800432e-02 6.129769633241683e-02 6.120776180293847e-02 6.111779589683188e-02 6.102779903735479e-02 + 6.093777158500626e-02 6.084771398591046e-02 6.075762667844817e-02 6.066751007308262e-02 6.057736455111417e-02 + 6.048719057054321e-02 6.039698864588414e-02 6.030675917961215e-02 6.021650256672047e-02 6.012621923377075e-02 + 6.003590961818356e-02 5.994557411659043e-02 5.985521308639186e-02 5.976482706463886e-02 5.967441656528669e-02 + 5.958398192281734e-02 5.949352353003544e-02 5.940304183449088e-02 5.931253730252380e-02 5.922201027916447e-02 + 5.913146112197507e-02 5.904089044032181e-02 5.895029868043596e-02 5.885968615096351e-02 5.876905326755812e-02 + 5.867840050492581e-02 5.858772833116550e-02 5.849703703991720e-02 5.840632705235495e-02 5.831559896255584e-02 + 5.822485314806121e-02 5.813408997000494e-02 5.804330987759122e-02 5.795251328764216e-02 5.786170059865808e-02 + 5.777087221384987e-02 5.768002859772193e-02 5.758917021647553e-02 5.749829746896256e-02 5.740741077575853e-02 + 5.731651056875526e-02 5.722559725171274e-02 5.713467118430270e-02 5.704373274635539e-02 5.695278249332581e-02 + 5.686182088614487e-02 5.677084826809927e-02 5.667986504336005e-02 5.658887165217444e-02 5.649786853613976e-02 + 5.640685602792318e-02 5.631583453941855e-02 5.622480462822738e-02 5.613376666437993e-02 5.604272100502515e-02 + 5.595166813210956e-02 5.586060845174765e-02 5.576954232437998e-02 5.567847012652845e-02 5.558739236715193e-02 + 5.549630955542323e-02 5.540522197136583e-02 5.531413002536285e-02 5.522303422299683e-02 5.513193492275553e-02 + 5.504083247717721e-02 5.494972729209355e-02 5.485861988753332e-02 5.476751071228679e-02 5.467640010379995e-02 + 5.458528846418693e-02 5.449417622493567e-02 5.440306381105370e-02 5.431195155656662e-02 5.422083985771245e-02 + 5.412972927459819e-02 5.403862019627870e-02 5.394751295390937e-02 5.385640797531270e-02 5.376530569364821e-02 + 5.367420650537214e-02 5.358311072889269e-02 5.349201882499156e-02 5.340093132499041e-02 5.330984856991542e-02 + 5.321877091980749e-02 5.312769879767464e-02 5.303663263591166e-02 5.294557280318667e-02 5.285451962473617e-02 + 5.276347361952855e-02 5.267243525955664e-02 5.258140485845194e-02 5.249038280640431e-02 5.239936952998326e-02 + 5.230836544276557e-02 5.221737088032564e-02 5.212638621732711e-02 5.203541199430900e-02 5.194444860919033e-02 + 5.185349638284296e-02 5.176255572471577e-02 5.167162705674897e-02 5.158071077330502e-02 5.148980718747074e-02 + 5.139891673261619e-02 5.130803993485430e-02 5.121717713356427e-02 5.112632867301793e-02 5.103549496777923e-02 + 5.094467643725986e-02 5.085387344650644e-02 5.076308630673339e-02 5.067231551219451e-02 5.058156153920812e-02 + 5.049082469322039e-02 5.040010534612100e-02 5.030940391348503e-02 5.021872080090227e-02 5.012805633824483e-02 + 5.003741087422633e-02 4.994678493647212e-02 4.985617892926745e-02 4.976559315779018e-02 4.967502801470126e-02 + 4.958448390876292e-02 4.949396122643934e-02 4.940346027599988e-02 4.931298146262254e-02 4.922252530167843e-02 + 4.913209213539834e-02 4.904168229174269e-02 4.895129616994274e-02 4.886093417404704e-02 4.877059666413559e-02 + 4.868028394034647e-02 4.858999646754281e-02 4.849973472130898e-02 4.840949900241633e-02 4.831928966152828e-02 + 4.822910709871525e-02 4.813895171199074e-02 4.804882382564480e-02 4.795872376124456e-02 4.786865202942978e-02 + 4.777860903855367e-02 4.768859507592742e-02 4.759861051627762e-02 4.750865575639699e-02 4.741873117406014e-02 + 4.732883706721817e-02 4.723897381137243e-02 4.714914191200375e-02 4.705934171189571e-02 4.696957351961628e-02 + 4.687983771740974e-02 4.679013469431771e-02 4.670046480338604e-02 4.661082833156779e-02 4.652122571187634e-02 + 4.643165741520618e-02 4.634212373882778e-02 4.625262501422293e-02 4.616316162482947e-02 4.607373395212459e-02 + 4.598434231610999e-02 4.589498701904484e-02 4.580566854223844e-02 4.571638729424802e-02 4.562714355109129e-02 + 4.553793766452621e-02 4.544877001582995e-02 4.535964097502848e-02 4.527055082898004e-02 4.518149992236756e-02 + 4.509248874970542e-02 4.500351765014129e-02 4.491458690878355e-02 4.482569689376779e-02 4.473684797939540e-02 + 4.464804050747698e-02 4.455927474828068e-02 4.447055110499822e-02 4.438187004531898e-02 4.429323185876936e-02 + 4.420463685202721e-02 4.411608538888854e-02 4.402757783926076e-02 4.393911451733543e-02 4.385069570127949e-02 + 4.376232184208732e-02 4.367399334643604e-02 4.358571047769912e-02 4.349747356709084e-02 4.340928298020802e-02 + 4.332113907381294e-02 4.323304212320113e-02 4.314499244129432e-02 4.305699050668390e-02 4.296903665620930e-02 + 4.288113115167341e-02 4.279327434447749e-02 4.270546659199307e-02 4.261770822231841e-02 4.252999949469098e-02 + 4.244234077853745e-02 4.235473252680039e-02 4.226717502474875e-02 4.217966855846760e-02 4.209221347273914e-02 + 4.200481011967518e-02 4.191745880279663e-02 4.183015977695443e-02 4.174291346429643e-02 4.165572027077732e-02 + 4.156858044734360e-02 4.148149429654668e-02 4.139446216241891e-02 4.130748439363172e-02 4.122056125606220e-02 + 4.113369302794675e-02 4.104688016346336e-02 4.096012300095512e-02 4.087342178434451e-02 4.078677683583759e-02 + 4.070018849668031e-02 4.061365708919899e-02 4.052718285106741e-02 4.044076611819490e-02 4.035440733833207e-02 + 4.026810678092279e-02 4.018186470341873e-02 4.009568143909095e-02 4.000955732298062e-02 3.992349264534106e-02 + 3.983748763759326e-02 3.975154269055037e-02 3.966565820546299e-02 3.957983441649049e-02 3.949407160357907e-02 + 3.940837009289332e-02 3.932273021031552e-02 3.923715221270428e-02 3.915163635394041e-02 3.906618306202975e-02 + 3.898079266950179e-02 3.889546539672872e-02 3.881020154253283e-02 3.872500143016262e-02 3.863986536923758e-02 + 3.855479358615301e-02 3.846978637959592e-02 3.838484417257106e-02 3.829996723484980e-02 3.821515580420295e-02 + 3.813041018714970e-02 3.804573069687705e-02 3.796111761198420e-02 3.787657114752344e-02 3.779209165765486e-02 + 3.770767953120019e-02 3.762333499040284e-02 3.753905829251161e-02 3.745484974542636e-02 3.737070965331050e-02 + 3.728663825939783e-02 3.720263578933122e-02 3.711870264209954e-02 3.703483914671073e-02 3.695104550519348e-02 + 3.686732199057993e-02 3.678366890490292e-02 3.670008654113079e-02 3.661657511036890e-02 3.653313487804630e-02 + 3.644976625150438e-02 3.636646948823320e-02 3.628324479604935e-02 3.620009246605282e-02 3.611701279349350e-02 + 3.603400604041686e-02 3.595107239910939e-02 3.586821219020735e-02 3.578542579441001e-02 3.570271341631447e-02 + 3.562007528519529e-02 3.553751169069794e-02 3.545502291550906e-02 3.537260919186706e-02 3.529027072401183e-02 + 3.520800787214007e-02 3.512582095428173e-02 3.504371015751370e-02 3.496167573051010e-02 3.487971795476078e-02 + 3.479783710598274e-02 3.471603337811516e-02 3.463430699965583e-02 3.455265835796009e-02 3.447108770848941e-02 + 3.438959523450754e-02 3.430818119554624e-02 3.422684586511945e-02 3.414558949343227e-02 3.406441225419257e-02 + 3.398331443038755e-02 3.390229638782512e-02 3.382135832287533e-02 3.374050043789544e-02 3.365972299780525e-02 + 3.357902626321113e-02 3.349841045119794e-02 3.341787574130316e-02 3.333742246166845e-02 3.325705092272905e-02 + 3.317676129391954e-02 3.309655379649919e-02 3.301642868788483e-02 3.293638622159571e-02 3.285642658240021e-02 + 3.277654996949401e-02 3.269675673538998e-02 3.261704712715797e-02 3.253742130855802e-02 3.245787951722746e-02 + 3.237842200259459e-02 3.229904899349424e-02 3.221976065258773e-02 3.214055722659278e-02 3.206143905506719e-02 + 3.198240632628265e-02 3.190345921865954e-02 3.182459797365254e-02 3.174582282841434e-02 3.166713398447476e-02 + 3.158853160183031e-02 3.151001597036992e-02 3.143158738592136e-02 3.135324600516137e-02 3.127499202279022e-02 + 3.119682567104914e-02 3.111874718036912e-02 3.104075672462514e-02 3.096285447683152e-02 3.088504075536903e-02 + 3.080731579690068e-02 3.072967974437236e-02 3.065213281019982e-02 3.057467522135681e-02 3.049730718652442e-02 + 3.042002885157935e-02 3.034284042889533e-02 3.026574223701538e-02 3.018873445294931e-02 3.011181722724549e-02 + 3.003499077734359e-02 2.995825532248887e-02 2.988161104857855e-02 2.980505808548691e-02 2.972859668986686e-02 + 2.965222714891759e-02 2.957594959806504e-02 2.949976420500935e-02 2.942367118266701e-02 2.934767073798247e-02 + 2.927176302885600e-02 2.919594820074298e-02 2.912022654108078e-02 2.904459827654108e-02 2.896906352751058e-02 + 2.889362247668933e-02 2.881827533028623e-02 2.874302228403363e-02 2.866786346167200e-02 2.859279903706265e-02 + 2.851782931145582e-02 2.844295445253672e-02 2.836817458182308e-02 2.829348988995876e-02 2.821890057629359e-02 + 2.814440681221589e-02 2.807000870175516e-02 2.799570646465742e-02 2.792150037589211e-02 2.784739055623231e-02 + 2.777337714638600e-02 2.769946033688953e-02 2.762564030841585e-02 2.755191720229608e-02 2.747829114116882e-02 + 2.740476237631904e-02 2.733133112357609e-02 2.725799748998750e-02 2.718476162641247e-02 2.711162371095654e-02 + 2.703858392279279e-02 2.696564237390275e-02 2.689279920452167e-02 2.682005468428394e-02 2.674740897239565e-02 + 2.667486216835663e-02 2.660241443488607e-02 2.653006594727732e-02 2.645781686062815e-02 2.638566726160998e-02 + 2.631361733435826e-02 2.624166733570949e-02 2.616981737012440e-02 2.609806754771221e-02 2.602641803533937e-02 + 2.595486900051258e-02 2.588342056814261e-02 2.581207282360541e-02 2.574082599292273e-02 2.566968028470076e-02 + 2.559863577456860e-02 2.552769259041796e-02 2.545685089381796e-02 2.538611083889939e-02 2.531547252137675e-02 + 2.524493605061727e-02 2.517450166747065e-02 2.510416952086314e-02 2.503393968681819e-02 2.496381230163825e-02 + 2.489378751859868e-02 2.482386547683629e-02 2.475404624292582e-02 2.468432996264991e-02 2.461471687229032e-02 + 2.454520706873932e-02 2.447580063686782e-02 2.440649771598710e-02 2.433729844997764e-02 2.426820294893469e-02 + 2.419921127712116e-02 2.413032362216684e-02 2.406154017790910e-02 2.399286100816565e-02 2.392428621229386e-02 + 2.385581592554643e-02 2.378745028409909e-02 2.371918936700126e-02 2.365103325041379e-02 2.358298215018098e-02 + 2.351503620457756e-02 2.344719546326070e-02 2.337946004127276e-02 2.331183006962702e-02 2.324430566419196e-02 + 2.317688687789637e-02 2.310957382435168e-02 2.304236671579298e-02 2.297526563441205e-02 2.290827063843882e-02 + 2.284138184722980e-02 2.277459938171355e-02 2.270792333404544e-02 2.264135374860772e-02 2.257489077729924e-02 + 2.250853459738779e-02 2.244228525780410e-02 2.237614283279474e-02 2.231010743473913e-02 2.224417917668724e-02 + 2.217835812285958e-02 2.211264432248330e-02 2.204703795931322e-02 2.198153916317220e-02 2.191614796666107e-02 + 2.185086445220271e-02 2.178568872592581e-02 2.172062089111306e-02 2.165566098457172e-02 2.159080908357505e-02 + 2.152606537366001e-02 2.146142993110024e-02 2.139690279242156e-02 2.133248404619538e-02 2.126817379406035e-02 + 2.120397211607284e-02 2.113987903003668e-02 2.107589465469217e-02 2.101201915594272e-02 2.094825256288664e-02 + 2.088459492231405e-02 2.082104632696408e-02 2.075760686991806e-02 2.069427660166107e-02 2.063105554609518e-02 + 2.056794384972622e-02 2.050494162894281e-02 2.044204890243054e-02 2.037926573000831e-02 2.031659219454509e-02 + 2.025402837653619e-02 2.019157429898307e-02 2.012923000978476e-02 2.006699566765361e-02 2.000487133731908e-02 + 1.994285703240835e-02 1.988095281849638e-02 1.981915877663429e-02 1.975747497137283e-02 1.969590139839621e-02 + 1.963443814246610e-02 1.957308535571834e-02 1.951184305296579e-02 1.945071125524195e-02 1.938969003470093e-02 + 1.932877945979973e-02 1.926797956444602e-02 1.920729035294688e-02 1.914671194302782e-02 1.908624443873623e-02 + 1.902588783798898e-02 1.896564217312377e-02 1.890550750534374e-02 1.884548390173623e-02 1.878557136933607e-02 + 1.872576992282937e-02 1.866607969751645e-02 1.860650074902563e-02 1.854703306920867e-02 1.848767670108510e-02 + 1.842843170242723e-02 1.836929811895166e-02 1.831027593341436e-02 1.825136519709141e-02 1.819256603897189e-02 + 1.813387846842225e-02 1.807530248298604e-02 1.801683812530333e-02 1.795848544988909e-02 1.790024447932676e-02 + 1.784211518704799e-02 1.778409766075985e-02 1.772619199567190e-02 1.766839817113224e-02 1.761071619932593e-02 + 1.755314612276550e-02 1.749568797940397e-02 1.743834176385679e-02 1.738110747126647e-02 1.732398520795971e-02 + 1.726697501687009e-02 1.721007686976607e-02 1.715329079150987e-02 1.709661681774517e-02 1.704005496995066e-02 + 1.698360522175755e-02 1.692726759648597e-02 1.687104219632033e-02 1.681492902190890e-02 1.675892805218375e-02 + 1.670303930866012e-02 1.664726282100333e-02 1.659159859573434e-02 1.653604659349284e-02 1.648060687061485e-02 + 1.642527950537791e-02 1.637006446137386e-02 1.631496172845883e-02 1.625997133117372e-02 1.620509328829045e-02 + 1.615032758053278e-02 1.609567417924041e-02 1.604113316306734e-02 1.598670456411958e-02 1.593238833576510e-02 + 1.587818448257840e-02 1.582409302120838e-02 1.577011395254391e-02 1.571624723647299e-02 1.566249287063067e-02 + 1.560885093721684e-02 1.555532142372995e-02 1.550190428691725e-02 1.544859953345741e-02 1.539540716895692e-02 + 1.534232718045593e-02 1.528935952298772e-02 1.523650422043375e-02 1.518376132655854e-02 1.513113080051426e-02 + 1.507861261080395e-02 1.502620675643192e-02 1.497391324399307e-02 1.492173204313831e-02 1.486966309840608e-02 + 1.481770646058926e-02 1.476586215324725e-02 1.471413011485714e-02 1.466251032223325e-02 1.461100277337298e-02 + 1.455960746411957e-02 1.450832433725036e-02 1.445715335761371e-02 1.440609458945226e-02 1.435514801148310e-02 + 1.430431355790390e-02 1.425359121341204e-02 1.420298097105418e-02 1.415248280845771e-02 1.410209665546564e-02 + 1.405182250942155e-02 1.400166041623447e-02 1.395161031395394e-02 1.390167215017196e-02 1.385184591619880e-02 + 1.380213159317199e-02 1.375252913341631e-02 1.370303846818604e-02 1.365365962256361e-02 1.360439260851619e-02 + 1.355523734898775e-02 1.350619380184460e-02 1.345726194685572e-02 1.340844175819677e-02 1.335973317080697e-02 + 1.331113613029375e-02 1.326265067233158e-02 1.321427676765317e-02 1.316601433678336e-02 1.311786334248669e-02 + 1.306982375879771e-02 1.302189555021592e-02 1.297407863461756e-02 1.292637298076667e-02 1.287877861455418e-02 + 1.283129547339001e-02 1.278392348592105e-02 1.273666261347862e-02 1.268951282495219e-02 1.264247406704279e-02 + 1.259554625321822e-02 1.254872937642621e-02 1.250202343522368e-02 1.245542834900525e-02 1.240894405313941e-02 + 1.236257050462080e-02 1.231630767029411e-02 1.227015547343941e-02 1.222411383176151e-02 1.217818275998809e-02 + 1.213236222220244e-02 1.208665212384520e-02 1.204105241018576e-02 1.199556303854240e-02 1.195018395838791e-02 + 1.190491507365890e-02 1.185975632952753e-02 1.181470773836339e-02 1.176976922480089e-02 1.172494069835479e-02 + 1.168022211004454e-02 1.163561340968965e-02 1.159111452823667e-02 1.154672536811994e-02 1.150244589927961e-02 + 1.145827610670764e-02 1.141421589534856e-02 1.137026518661645e-02 1.132642392502224e-02 1.128269205281729e-02 + 1.123906948383837e-02 1.119555612518262e-02 1.115215196588227e-02 1.110885695891592e-02 1.106567099667937e-02 + 1.102259400831050e-02 1.097962593601935e-02 1.093676671505125e-02 1.089401623812122e-02 1.085137442757511e-02 + 1.080884127911701e-02 1.076641671182367e-02 1.072410061923310e-02 1.068189293399554e-02 1.063979359231152e-02 + 1.059780251428707e-02 1.055591958418482e-02 1.051414475108346e-02 1.047247799305691e-02 1.043091920126454e-02 + 1.038946827795377e-02 1.034812515386981e-02 1.030688975996647e-02 1.026576200007446e-02 1.022474176231751e-02 + 1.018382901647819e-02 1.014302370834395e-02 1.010232571551464e-02 1.006173495028295e-02 1.002125134058496e-02 + 9.980874808217161e-03 9.940605238090998e-03 9.900442533803457e-03 9.860386673211879e-03 9.820437566105797e-03 + 9.780595089730604e-03 9.740859166502601e-03 9.701229717604148e-03 9.661706648486619e-03 9.622289837555094e-03 + 9.582979211676392e-03 9.543774731762645e-03 9.504676285752028e-03 9.465683761437204e-03 9.426797070527869e-03 + 9.388016130061547e-03 9.349340837763126e-03 9.310771071700266e-03 9.272306774287777e-03 9.233947879847340e-03 + 9.195694263233465e-03 9.157545820041815e-03 9.119502462398593e-03 9.081564104605406e-03 9.043730620594144e-03 + 9.006001891771507e-03 8.968377884117109e-03 8.930858503326412e-03 8.893443610144467e-03 8.856133108771761e-03 + 8.818926910576046e-03 8.781824915337199e-03 8.744826984807866e-03 8.707933026764444e-03 8.671142997995955e-03 + 8.634456771198624e-03 8.597874217863410e-03 8.561395247729468e-03 8.525019762147885e-03 8.488747643810387e-03 + 8.452578758551675e-03 8.416513035074836e-03 8.380550402064440e-03 8.344690718755845e-03 8.308933866062409e-03 + 8.273279745485652e-03 8.237728259206089e-03 8.202279277607399e-03 8.166932668725525e-03 8.131688373197346e-03 + 8.096546291813443e-03 8.061506280849479e-03 8.026568229604077e-03 7.991732033790425e-03 7.956997581179438e-03 + 7.922364735477982e-03 7.887833385768220e-03 7.853403460644042e-03 7.819074838170454e-03 7.784847385209607e-03 + 7.750720988388416e-03 7.716695538073770e-03 7.682770912288046e-03 7.648946965667346e-03 7.615223607644973e-03 + 7.581600758648286e-03 7.548078272068747e-03 7.514656018308716e-03 7.481333888256649e-03 7.448111767084748e-03 + 7.414989518558892e-03 7.381967002509678e-03 7.349044141005179e-03 7.316220829119200e-03 7.283496916229069e-03 + 7.250872276568530e-03 7.218346796125786e-03 7.185920358959778e-03 7.153592811909379e-03 7.121364026156801e-03 + 7.089233934032213e-03 7.057202401526107e-03 7.025269274784423e-03 6.993434437254338e-03 6.961697770726437e-03 + 6.930059144137623e-03 6.898518406074085e-03 6.867075445461445e-03 6.835730169890301e-03 6.804482436531050e-03 + 6.773332103630715e-03 6.742279042830752e-03 6.711323134446215e-03 6.680464239400761e-03 6.649702204950062e-03 + 6.619036937093537e-03 6.588468325547939e-03 6.557996212108587e-03 6.527620458965777e-03 6.497340941897300e-03 + 6.467157538628341e-03 6.437070090473932e-03 6.407078453159759e-03 6.377182548096138e-03 6.347382238649846e-03 + 6.317677359750170e-03 6.288067782822399e-03 6.258553381641384e-03 6.229134019133821e-03 6.199809533909972e-03 + 6.170579803332374e-03 6.141444731866248e-03 6.112404164377095e-03 6.083457948651627e-03 6.054605954063168e-03 + 6.025848047899531e-03 5.997184082520315e-03 5.968613898555075e-03 5.940137388272029e-03 5.911754435973001e-03 + 5.883464876798197e-03 5.855268565478542e-03 5.827165369238958e-03 5.799155152943781e-03 5.771237757858197e-03 + 5.743413031370796e-03 5.715680873423079e-03 5.688041146137241e-03 5.660493683352233e-03 5.633038344713090e-03 + 5.605674994693767e-03 5.578403490874967e-03 5.551223666073857e-03 5.524135383482108e-03 5.497138538622371e-03 + 5.470232973711985e-03 5.443418527865922e-03 5.416695061766649e-03 5.390062436684385e-03 5.363520500801443e-03 + 5.337069085950208e-03 5.310708070645691e-03 5.284437334686721e-03 5.258256709167105e-03 5.232166039984466e-03 + 5.206165186351173e-03 5.180254006079314e-03 5.154432337116667e-03 5.128700017566677e-03 5.103056934758595e-03 + 5.077502948400768e-03 5.052037887552509e-03 5.026661602896529e-03 5.001373950974750e-03 4.976174783805283e-03 + 4.951063931174483e-03 4.926041244835856e-03 4.901106610871052e-03 4.876259869861805e-03 4.851500854152867e-03 + 4.826829416485723e-03 4.802245411238555e-03 4.777748682676776e-03 4.753339057595283e-03 4.729016402174706e-03 + 4.704780591018902e-03 4.680631452386119e-03 4.656568824906738e-03 4.632592561043116e-03 4.608702512089780e-03 + 4.584898512841469e-03 4.561180394112987e-03 4.537548032865621e-03 4.514001286180084e-03 4.490539978046344e-03 + 4.467163952568486e-03 4.443873060291688e-03 4.420667147623122e-03 4.397546041481102e-03 4.374509584352294e-03 + 4.351557654555007e-03 4.328690090868674e-03 4.305906719484884e-03 4.283207387010587e-03 4.260591942258349e-03 + 4.238060226010617e-03 4.215612060889534e-03 4.193247302342208e-03 4.170965820265097e-03 4.148767441443334e-03 + 4.126651998168965e-03 4.104619336614093e-03 4.082669303050944e-03 4.060801730082235e-03 4.039016442831475e-03 + 4.017313308452854e-03 3.995692181792875e-03 3.974152883344686e-03 3.952695251163741e-03 3.931319130911208e-03 + 3.910024364917125e-03 3.888810777810686e-03 3.867678204037116e-03 3.846626514691173e-03 3.825655547709963e-03 + 3.804765124734014e-03 3.783955087456414e-03 3.763225279741349e-03 3.742575538839424e-03 3.722005684569956e-03 + 3.701515563829318e-03 3.681105042529648e-03 3.660773945892437e-03 3.640522100973796e-03 3.620349349516141e-03 + 3.600255533338096e-03 3.580240483202974e-03 3.560304020332013e-03 3.540446002992503e-03 3.520666284206718e-03 + 3.500964682823155e-03 3.481341031384374e-03 3.461795171007476e-03 3.442326941040924e-03 3.422936165061433e-03 + 3.403622671201535e-03 3.384386323473485e-03 3.365226959961049e-03 3.346144399498565e-03 3.327138478378434e-03 + 3.308209036536853e-03 3.289355909461925e-03 3.270578915351533e-03 3.251877893639187e-03 3.233252706195778e-03 + 3.214703178029928e-03 3.196229132118811e-03 3.177830406368320e-03 3.159506839403438e-03 3.141258260810600e-03 + 3.123084488811596e-03 3.104985374197366e-03 3.086960768611876e-03 3.069010490077185e-03 3.051134366997480e-03 + 3.033332237019262e-03 3.015603936903380e-03 2.997949290147841e-03 2.980368120588831e-03 2.962860285290425e-03 + 2.945425622240710e-03 2.928063948810786e-03 2.910775098113858e-03 2.893558906982335e-03 2.876415208617919e-03 + 2.859343821344898e-03 2.842344578930633e-03 2.825417338731532e-03 2.808561926446875e-03 2.791778162629514e-03 + 2.775065882662152e-03 2.758424922052246e-03 2.741855109318431e-03 2.725356262118107e-03 2.708928224810950e-03 + 2.692570847204586e-03 2.676283947708203e-03 2.660067352018658e-03 2.643920895408666e-03 2.627844412630983e-03 + 2.611837727127577e-03 2.595900659591014e-03 2.580033062057212e-03 2.564234773200918e-03 2.548505609580814e-03 + 2.532845401329118e-03 2.517253983314282e-03 2.501731188088862e-03 2.486276834298587e-03 2.470890751027053e-03 + 2.455572791828030e-03 2.440322784214469e-03 2.425140547489158e-03 2.410025914370114e-03 2.394978718743150e-03 + 2.379998789312335e-03 2.365085943631231e-03 2.350240020749269e-03 2.335460868942443e-03 2.320748308349550e-03 + 2.306102163022297e-03 2.291522266200105e-03 2.277008450857895e-03 2.262560541519312e-03 2.248178358404482e-03 + 2.233861748393963e-03 2.219610550590767e-03 2.205424582540762e-03 2.191303672653564e-03 2.177247654150935e-03 + 2.163256358437406e-03 2.149329606085116e-03 2.135467224025938e-03 2.121669062135428e-03 2.107934949596006e-03 + 2.094264705479671e-03 2.080658161247730e-03 2.067115150052171e-03 2.053635501035216e-03 2.040219032033609e-03 + 2.026865578574763e-03 2.013574988607888e-03 2.000347084189316e-03 1.987181688126059e-03 1.974078632294973e-03 + 1.961037750159034e-03 1.948058867783843e-03 1.935141804192390e-03 1.922286403096425e-03 1.909492504980594e-03 + 1.896759928265229e-03 1.884088500763132e-03 1.871478055631251e-03 1.858928424089599e-03 1.846439428400912e-03 + 1.834010894228015e-03 1.821642669213327e-03 1.809334584628213e-03 1.797086460037203e-03 1.784898126770644e-03 + 1.772769417737367e-03 1.760700162615002e-03 1.748690181778845e-03 1.736739308394668e-03 1.724847388831493e-03 + 1.713014248130287e-03 1.701239709792772e-03 1.689523605558227e-03 1.677865768960374e-03 1.666266027776910e-03 + 1.654724201747776e-03 1.643240132443950e-03 1.631813662093462e-03 1.620444610863358e-03 1.609132806416696e-03 + 1.597878082462674e-03 1.586680271167799e-03 1.575539197124769e-03 1.564454685806544e-03 1.553426583192850e-03 + 1.542454723186195e-03 1.531538926942232e-03 1.520679025889417e-03 1.509874853790604e-03 1.499126242122267e-03 + 1.488433013507451e-03 1.477795000037597e-03 1.467212048115432e-03 1.456683985464255e-03 1.446210636719452e-03 + 1.435791835117153e-03 1.425427414393694e-03 1.415117204211151e-03 1.404861027594662e-03 1.394658724273689e-03 + 1.384510137356095e-03 1.374415090575271e-03 1.364373412382042e-03 1.354384937246215e-03 1.344449499301808e-03 + 1.334566925970926e-03 1.324737043332181e-03 1.314959696939330e-03 1.305234723823342e-03 1.295561947265019e-03 + 1.285941199528206e-03 1.276372315963847e-03 1.266855130463658e-03 1.257389468322312e-03 1.247975161599065e-03 + 1.238612057815808e-03 1.229299987951490e-03 1.220038778115428e-03 1.210828263449681e-03 1.201668279419893e-03 + 1.192558658328712e-03 1.183499226491516e-03 1.174489822883548e-03 1.165530291825810e-03 1.156620461345326e-03 + 1.147760161971411e-03 1.138949229776032e-03 1.130187500878873e-03 1.121474806129454e-03 1.112810973708310e-03 + 1.104195848566657e-03 1.095629271185936e-03 1.087111069073448e-03 1.078641075658101e-03 1.070219127753748e-03 + 1.061845062287274e-03 1.053518708913237e-03 1.045239900848634e-03 1.037008485418972e-03 1.028824298155823e-03 + 1.020687168641753e-03 1.012596933141099e-03 1.004553429894111e-03 9.965564952721074e-04 9.886059579764911e-04 + 9.807016577383673e-04 9.728434421263681e-04 9.650311428619217e-04 9.572645925441391e-04 9.495436296868831e-04 + 9.418680934992058e-04 9.342378189983833e-04 9.266526374013966e-04 9.191123940951565e-04 9.116169327210938e-04 + 9.041660846048507e-04 8.967596865276394e-04 8.893975784458786e-04 8.820795994475233e-04 8.748055834052338e-04 + 8.675753662309574e-04 8.603887967412885e-04 8.532457145816050e-04 8.461459528881801e-04 8.390893515597134e-04 + 8.320757512954288e-04 8.251049910410551e-04 8.181769052102455e-04 8.112913354889369e-04 8.044481307476467e-04 + 7.976471276304203e-04 7.908881626723219e-04 7.841710779271092e-04 7.774957151422038e-04 7.708619131557394e-04 + 7.642695077220146e-04 7.577183458379644e-04 7.512082748417916e-04 7.447391309361296e-04 7.383107537219758e-04 + 7.319229861740803e-04 7.255756719189899e-04 7.192686493738265e-04 7.130017570250109e-04 7.067748463319056e-04 + 7.005877618919097e-04 6.944403408515077e-04 6.883324261093659e-04 6.822638623160529e-04 6.762344932684062e-04 + 6.702441573916524e-04 6.642926986443232e-04 6.583799694858947e-04 6.525058122102392e-04 6.466700672293728e-04 + 6.408725793807691e-04 6.351131947715911e-04 6.293917574305099e-04 6.237081070877600e-04 6.180620932909059e-04 + 6.124535677685099e-04 6.068823714677426e-04 6.013483481700967e-04 5.958513451670206e-04 5.903912096703989e-04 + 5.849677853780454e-04 5.795809154020751e-04 5.742304534677881e-04 5.689162489783443e-04 5.636381442526738e-04 + 5.583959863498279e-04 5.531896240506697e-04 5.480189055622431e-04 5.428836748799696e-04 5.377837797240800e-04 + 5.327190759830209e-04 5.276894110958636e-04 5.226946300477827e-04 5.177345825024617e-04 5.128091188465486e-04 + 5.079180879528710e-04 5.030613351067660e-04 4.982387130290541e-04 4.934500776624026e-04 4.886952758062522e-04 + 4.839741558713263e-04 4.792865695826084e-04 4.746323688630657e-04 4.700114029595036e-04 4.654235198613055e-04 + 4.608685766627245e-04 4.563464280591107e-04 4.518569219186994e-04 4.473999099762359e-04 4.429752457691277e-04 + 4.385827824909558e-04 4.342223700107388e-04 4.298938604566902e-04 4.255971135329090e-04 4.213319826090788e-04 + 4.170983180859963e-04 4.128959744299958e-04 4.087248069577171e-04 4.045846700338900e-04 4.004754147907325e-04 + 3.963968979642262e-04 3.923489801919561e-04 3.883315144592717e-04 3.843443544269981e-04 3.803873568608614e-04 + 3.764603788261386e-04 3.725632754784107e-04 3.686959004384349e-04 3.648581147870281e-04 3.610497787686854e-04 + 3.572707463878945e-04 3.535208745539621e-04 3.498000220657478e-04 3.461080477383748e-04 3.424448076363575e-04 + 3.388101589386426e-04 3.352039657815740e-04 3.316260877532703e-04 3.280763812137888e-04 3.245547060139738e-04 + 3.210609229167205e-04 3.175948921405597e-04 3.141564711604799e-04 3.107455215081982e-04 3.073619088757455e-04 + 3.040054927848886e-04 3.006761327105527e-04 2.973736909925681e-04 2.940980303881470e-04 2.908490123115160e-04 + 2.876264965105581e-04 2.844303488008553e-04 2.812604353029198e-04 2.781166164989417e-04 2.749987551423296e-04 + 2.719067158817455e-04 2.688403633742989e-04 2.657995602462465e-04 2.627841695326067e-04 2.597940603791381e-04 + 2.568290988582687e-04 2.538891477672460e-04 2.509740728301346e-04 2.480837407612393e-04 2.452180180501483e-04 + 2.423767689150773e-04 2.395598604007145e-04 2.367671637065971e-04 2.339985452156380e-04 2.312538707417314e-04 + 2.285330086975239e-04 2.258358279521211e-04 2.231621965330517e-04 2.205119809474630e-04 2.178850522930381e-04 + 2.152812827957872e-04 2.127005401044592e-04 2.101426932429596e-04 2.076076129630843e-04 2.050951703707553e-04 + 2.026052350574154e-04 2.001376764695323e-04 1.976923692963255e-04 1.952691863631026e-04 1.928679973631469e-04 + 1.904886744667185e-04 1.881310908124045e-04 1.857951194428946e-04 1.834806317739651e-04 1.811875010647571e-04 + 1.789156043640377e-04 1.766648152326652e-04 1.744350063601967e-04 1.722260526922104e-04 1.700378296945535e-04 + 1.678702123432160e-04 1.657230742438847e-04 1.635962925697728e-04 1.614897461072756e-04 1.594033097074569e-04 + 1.573368592094730e-04 1.552902721810668e-04 1.532634264532060e-04 1.512561988693490e-04 1.492684659352835e-04 + 1.473001083560244e-04 1.453510059716440e-04 1.434210358729406e-04 1.415100771164913e-04 1.396180097223186e-04 + 1.377447137267307e-04 1.358900680130841e-04 1.340539526362652e-04 1.322362510498252e-04 1.304368442346035e-04 + 1.286556121626104e-04 1.268924368411170e-04 1.251472007379926e-04 1.234197860690376e-04 1.217100740639766e-04 + 1.200179485071157e-04 1.183432949752447e-04 1.166859960758634e-04 1.150459349477667e-04 1.134229962637926e-04 + 1.118170649981152e-04 1.102280255615328e-04 1.086557620076939e-04 1.071001616642248e-04 1.055611117192228e-04 + 1.040384970703678e-04 1.025322040262462e-04 1.010421198490596e-04 9.956813202096472e-05 9.811012722455996e-05 + 9.666799283658755e-05 9.524161921027426e-05 9.383089505710078e-05 9.243570803818307e-05 9.105594759252440e-05 + 8.969150364397068e-05 8.834226604286881e-05 8.700812397260034e-05 8.568896841419017e-05 8.438469212608002e-05 + 8.309518568825200e-05 8.182033994906239e-05 8.056004718218619e-05 7.931419998170841e-05 7.808269064296404e-05 + 7.686541112857092e-05 7.566225594198306e-05 7.447311991364301e-05 7.329789600792314e-05 7.213647827366786e-05 + 7.098876170896106e-05 6.985464163907488e-05 6.873401282606521e-05 6.762677039259616e-05 6.653281205307769e-05 + 6.545203459530543e-05 6.438433381335806e-05 6.332960688869456e-05 6.228775159650499e-05 6.125866586213212e-05 + 6.024224709312662e-05 5.923839394811549e-05 5.824700680510711e-05 5.726798458845817e-05 5.630122626966778e-05 + 5.534663202079377e-05 5.440410243697520e-05 5.347353805513213e-05 5.255483915897720e-05 5.164790790372327e-05 + 5.075264706713765e-05 4.986895809670387e-05 4.899674321102013e-05 4.813590548272275e-05 4.728634834520723e-05 + 4.644797500988253e-05 4.562068892036128e-05 4.480439551815946e-05 4.399899988301035e-05 4.320440633696577e-05 + 4.242052030402665e-05 4.164724778526068e-05 4.088449502887978e-05 4.013216802138054e-05 3.939017361734100e-05 + 3.865842020891389e-05 3.793681530287127e-05 3.722526637683801e-05 3.652368195642655e-05 3.583197100166348e-05 + 3.515004257550265e-05 3.447780563338777e-05 3.381517049939420e-05 3.316204825033269e-05 3.251834908257212e-05 + 3.188398376275541e-05 3.125886384349450e-05 3.064290126992314e-05 3.003600797392098e-05 2.943809607683111e-05 + 2.884907925556903e-05 2.826887119646782e-05 2.769738505988399e-05 2.713453488302094e-05 2.658023526748751e-05 + 2.603440114263312e-05 2.549694738792051e-05 2.496778949423694e-05 2.444684425976710e-05 2.393402805764408e-05 + 2.342925723948219e-05 2.293244905822871e-05 2.244352120797989e-05 2.196239159983278e-05 2.148897818423003e-05 + 2.102319990982268e-05 2.056497650699234e-05 2.011422722229805e-05 1.967087173846936e-05 1.923483045310688e-05 + 1.880602417859793e-05 1.838437386840237e-05 1.796980069033951e-05 1.756222699777835e-05 1.716157539169325e-05 + 1.676776819323897e-05 1.638072842752046e-05 1.600037965967140e-05 1.562664583506045e-05 1.525945101785764e-05 + 1.489871974108943e-05 1.454437762041471e-05 1.419635018600421e-05 1.385456300630342e-05 1.351894241351905e-05 + 1.318941519258516e-05 1.286590843459537e-05 1.254834939298960e-05 1.223666606495489e-05 1.193078719950152e-05 + 1.163064137727749e-05 1.133615754527981e-05 1.104726530816775e-05 1.076389469662666e-05 1.048597599093073e-05 + 1.021343974753131e-05 9.946217419267380e-06 9.684240838620889e-06 9.427441790773100e-06 9.175752643853506e-06 + 8.929106280098344e-06 8.687435997194528e-06 8.450675338936148e-06 8.218758257424963e-06 7.991619584870982e-06 + 7.769194298227330e-06 7.551417507621627e-06 7.338224987041431e-06 7.129552955942858e-06 6.925337997222138e-06 + 6.725516977155444e-06 6.530027335862672e-06 6.338807194551445e-06 6.151794769434223e-06 5.968928615355085e-06 + 5.790147878391894e-06 5.615392155261267e-06 5.444601365246586e-06 5.277715758699128e-06 5.114676291438329e-06 + 4.955424365336747e-06 4.799901525655197e-06 4.648049820836300e-06 4.499811793985402e-06 4.355130438087899e-06 + 4.213949069835453e-06 4.076211399540344e-06 3.941861865039729e-06 3.810845196499976e-06 3.683106361660463e-06 + 3.558590910585118e-06 3.437244835818923e-06 3.319014541070219e-06 3.203846795533912e-06 3.091688852089737e-06 + 2.982488579295818e-06 2.876194109656037e-06 2.772753925582794e-06 2.672117063800105e-06 2.574233014808049e-06 + 2.479051643033932e-06 2.386523210361943e-06 2.296598552297165e-06 2.209228971591383e-06 2.124366069775506e-06 + 2.041961906232304e-06 1.961969019732135e-06 1.884340423438541e-06 1.809029507182080e-06 1.735990071613592e-06 + 1.665176534356502e-06 1.596543687803830e-06 1.530046658503296e-06 1.465641105678908e-06 1.403283128309336e-06 + 1.342929271825179e-06 1.284536503035511e-06 1.228062233226246e-06 1.173464436795038e-06 1.120701460082181e-06 + 1.069732028902882e-06 1.020515399241352e-06 9.730112822753146e-07 9.271798002921477e-07 8.829815278752155e-07 + 8.403775374680640e-07 7.993293716485992e-07 7.597989809176624e-07 7.217487560416926e-07 6.851415619710593e-07 + 6.499407524191172e-07 6.161100929136179e-07 5.836137918783888e-07 5.524166028233452e-07 5.224836968385216e-07 + 4.937806609639881e-07 4.662735849361845e-07 4.399289991547822e-07 4.147139110260500e-07 3.905957813609555e-07 + 3.675425084859321e-07 3.455225231396512e-07 3.245046871736890e-07 3.044582778536548e-07 2.853530928283095e-07 + 2.671593859185241e-07 2.498478511400059e-07 2.333896726605378e-07 2.177564985206194e-07 2.029204500538344e-07 + 1.888541210793108e-07 1.755305458522738e-07 1.629232393506973e-07 1.510062144201093e-07 1.397539174372155e-07 + 1.291412703741045e-07 1.191437050672961e-07 1.097370923617762e-07 1.008977778162274e-07 9.260259669902208e-08 + 8.482883141984319e-08 7.755426670738778e-08 7.075715683240311e-08 6.441620467100832e-08 5.851063608240125e-08 + 5.302013495440350e-08 4.792483459927075e-08 4.320538955913144e-08 3.884291294265582e-08 3.481898425658018e-08 + 3.111569527451850e-08 2.771559342817648e-08 2.460171067137196e-08 2.175758348333717e-08 1.916719757773861e-08 + 1.681503457183268e-08 1.468607978947252e-08 1.276576812429566e-08 1.104003874048358e-08 9.495328649625366e-09 + 8.118528715645258e-09 6.897042498203040e-09 5.818760232281117e-09 4.872032311209139e-09 4.045732447740840e-09 + 3.329210679517489e-09 2.712284881132093e-09 2.185301687016959e-09 1.739076161987666e-09 1.364901589086205e-09 + 1.054599065845252e-09 8.004535320102697e-10 5.952414597054672e-10 4.322622496028902e-10 3.052766304104823e-10 + 2.085502003918036e-10 1.368642901349301e-10 8.546164059834664e-11 5.010215808832263e-11 2.705311520847365e-11 + 1.304599438344934e-11 5.339090781311160e-12 1.692041320615927e-12 3.321208355096226e-13 6.781366937015517e-15 diff --git a/examples/SPIN/read_restart/in.spin.restart b/examples/SPIN/read_restart/in.spin.restart index ad6f337890..ccce25b254 100644 --- a/examples/SPIN/read_restart/in.spin.restart +++ b/examples/SPIN/read_restart/in.spin.restart @@ -44,6 +44,6 @@ thermo_style custom step time v_magnorm v_emag v_tmag temp etotal thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 100 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] run 100 diff --git a/examples/SPIN/read_restart/log.11May18.spin.read_data.g++.4 b/examples/SPIN/read_restart/log.11May18.spin.read_data.g++.4 deleted file mode 100644 index 56fed35307..0000000000 --- a/examples/SPIN/read_restart/log.11May18.spin.read_data.g++.4 +++ /dev/null @@ -1,112 +0,0 @@ -LAMMPS (11 May 2018) -units metal -dimension 3 -boundary p p p - -atom_style spin - -# necessary for the serial algorithm (sametag) -atom_modify map array -read_data Norm_randXY_8x8x32.data - orthogonal box = (0 0 0) to (28.32 28.32 113.28) - 1 by 1 by 4 MPI processor grid - reading atoms ... - 8192 atoms - -mass 1 58.93 - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 - -neighbor 1.0 bin -neigh_modify every 1 check no delay 0 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# define outputs and computes - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo 10 -thermo_style custom step time v_magnorm v_emag v_tmag temp etotal -thermo_modify format float %20.15g - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 10 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] - -run 100 -Neighbor list info ... - update every 1 steps, delay 0 steps, check no - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 7.49954 - ghost atom cutoff = 7.49954 - binsize = 3.74977, bins = 8 8 31 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 7.883 | 7.994 | 8.25 Mbytes -Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.980832325249103 -2984.9466433509 51.7121203365411 0 -38881.8459242507 - 10 0.001 0.980832325329477 -2984.94800197307 52.2550778515409 0.00128259391683994 -38881.8459243698 - 20 0.002 0.980832324654401 -2984.95196908569 53.4253110612179 0.00502068532291255 -38881.8459246487 - 30 0.003 0.98083232312993 -2984.95826683995 55.148898005011 0.0109316232931419 -38881.84592505 - 40 0.004 0.980832320808156 -2984.9664981035 57.3218040934977 0.0186091337978305 -38881.8459255198 - 50 0.005 0.980832317596783 -2984.97619813016 59.827198436387 0.0275752665472358 -38881.8459260035 - 60 0.006 0.980832313514709 -2984.98688847322 62.5519331668858 0.037334879488755 -38881.84592645 - 70 0.007 0.980832309220414 -2984.99812399537 65.3979760533737 0.0474235360022736 -38881.8459268243 - 80 0.008 0.980832304490479 -2985.00952678209 68.2863250613635 0.0574425728014485 -38881.8459271068 - 90 0.009 0.980832299379824 -2985.02080456789 71.1540940309591 0.0670788096168283 -38881.8459272917 - 100 0.01 0.980832294622694 -2985.03175503971 73.9487734241296 0.0761100584457276 -38881.8459273851 -Loop time of 3.6612 on 4 procs for 100 steps with 8192 atoms - -Performance: 0.236 ns/day, 101.700 hours/ns, 27.313 timesteps/s -98.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 | 1.0622 | 1.076 | 1.0936 | 1.1 | 29.39 -Neigh | 0.77462 | 0.79542 | 0.81798 | 1.9 | 21.73 -Comm | 0.024701 | 0.066122 | 0.10261 | 11.1 | 1.81 -Output | 0.50304 | 0.51253 | 0.52111 | 0.9 | 14.00 -Modify | 1.2006 | 1.2082 | 1.2205 | 0.7 | 33.00 -Other | | 0.002962 | | | 0.08 - -Nlocal: 2048 ave 2095 max 1981 min -Histogram: 1 0 0 0 0 0 2 0 0 1 -Nghost: 5765 ave 5832 max 5718 min -Histogram: 1 0 0 2 0 0 0 0 0 1 -Neighs: 143360 ave 146361 max 139058 min -Histogram: 1 0 0 0 0 0 1 1 0 1 -FullNghs: 286720 ave 293300 max 277340 min -Histogram: 1 0 0 0 0 0 2 0 0 1 - -Total # of neighbors = 1146880 -Ave neighs/atom = 140 -Neighbor list builds = 100 -Dangerous builds not checked - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:03 diff --git a/examples/SPIN/read_restart/log.11May18.spin.restart.g++.4 b/examples/SPIN/read_restart/log.11May18.spin.restart.g++.4 deleted file mode 100644 index f93605a10a..0000000000 --- a/examples/SPIN/read_restart/log.11May18.spin.restart.g++.4 +++ /dev/null @@ -1,118 +0,0 @@ -LAMMPS (11 May 2018) -# start a spin-lattice simulation from a data file -units metal -atom_style spin - -dimension 3 -boundary p p p - -# necessary for the serial algorithm (sametag) -atom_modify map array - -read_restart restart_hcp_cobalt.equil -WARNING: Restart file used different # of processors (../read_restart.cpp:723) - restoring atom style spin from restart - orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) - 1 by 2 by 2 MPI processor grid - restoring pair style spin/exchange from restart - 500 atoms - -# setting mass, mag. moments, and interactions - -mass 1 58.93 - -pair_style hybrid/overlay eam/alloy spin/exchange 4.0 -pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co -pair_coeff * * spin/exchange exchange 4.0 0.3593 1.135028015e-05 1.064568567 - -neighbor 1.0 bin -neigh_modify every 1 check no delay 0 - -fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 -fix 2 all langevin/spin 0.0 0.0 21 - -fix 3 all nve/spin lattice yes -timestep 0.0001 - -# define outputs - -compute out_mag all compute/spin -compute out_pe all pe -compute out_ke all ke -compute out_temp all temp - -variable magz equal c_out_mag[3] -variable magnorm equal c_out_mag[4] -variable emag equal c_out_mag[5] -variable tmag equal c_out_mag[6] - -thermo 10 -thermo_style custom step time v_magnorm v_emag v_tmag temp etotal -thermo_modify format float %20.15g - -compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 100 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] - -run 100 -Neighbor list info ... - update every 1 steps, delay 0 steps, check no - max neighbors/atom: 2000, page size: 100000 - master list distance cutoff = 7.49954 - ghost atom cutoff = 7.49954 - binsize = 3.74977, bins = 4 6 6 - 2 neighbor lists, perpetual/occasional/extra = 2 0 0 - (1) pair eam/alloy, perpetual, half/full from (2) - attributes: half, newton on - pair build: halffull/newton - stencil: none - bin: none - (2) pair spin/exchange, perpetual - attributes: full, newton on - pair build: full/bin/atomonly - stencil: full/bin/3d - bin: standard -Per MPI rank memory allocation (min/avg/max) = 6.203 | 6.203 | 6.203 Mbytes -Step Time v_magnorm v_emag v_tmag Temp TotEng - 1000 0 0.106120063678768 -11.8110267448939 5244.87332482316 0 -2206.81097898003 - 1010 0.001 0.106120030254187 -11.8198467883806 5263.87550015043 0.136650306637598 -2206.81097929055 - 1020 0.002 0.106119996655714 -11.8460960476455 5267.299198699 0.542282344092749 -2206.81098022997 - 1030 0.003 0.106119967407682 -11.8891433919665 5252.95473019843 1.20401809237154 -2206.81098172552 - 1040 0.004 0.106119960016585 -11.9479778326021 5220.88686874944 2.10120827278397 -2206.81098371049 - 1050 0.005 0.106119961252471 -12.0212426191481 5172.58712301374 3.20622343988728 -2206.81098610703 - 1060 0.006 0.106119967598995 -12.1072712483404 5110.57504803718 4.48535830705751 -2206.81098879724 - 1070 0.007 0.106119967669058 -12.2041566468564 5038.48927079832 5.90031039867811 -2206.81099161179 - 1080 0.008 0.106119969263395 -12.3098693905406 4961.03212459716 7.41044810751949 -2206.8109943465 - 1090 0.009 0.106119960964075 -12.4224156966204 4883.31968289062 8.97568865379831 -2206.81099680112 - 1100 0.01 0.106119945605273 -12.5400036591612 4809.87930844463 10.5594596175303 -2206.81099883101 -Loop time of 0.304678 on 4 procs for 100 steps with 500 atoms - -Performance: 2.836 ns/day, 8.463 hours/ns, 328.215 timesteps/s -98.0% 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.071445 | 0.073018 | 0.074151 | 0.4 | 23.97 -Neigh | 0.054448 | 0.055709 | 0.057528 | 0.5 | 18.28 -Comm | 0.0061178 | 0.0074609 | 0.0090766 | 1.2 | 2.45 -Output | 0.037489 | 0.038586 | 0.039952 | 0.5 | 12.66 -Modify | 0.12826 | 0.12954 | 0.13065 | 0.3 | 42.52 -Other | | 0.0003686 | | | 0.12 - -Nlocal: 125 ave 129 max 120 min -Histogram: 1 0 0 0 1 0 0 1 0 1 -Nghost: 1387 ave 1392 max 1383 min -Histogram: 1 0 1 0 0 1 0 0 0 1 -Neighs: 9125 ave 9428 max 8740 min -Histogram: 1 0 0 1 0 0 0 0 1 1 -FullNghs: 18250 ave 18834 max 17520 min -Histogram: 1 0 0 0 1 0 0 1 0 1 - -Total # of neighbors = 73000 -Ave neighs/atom = 146 -Neighbor list builds = 100 -Dangerous builds not checked - -Please see the log.cite file for references relevant to this simulation - -Total wall time: 0:00:00 diff --git a/examples/SPIN/read_restart/log.11May18.spin.read_data.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 similarity index 50% rename from examples/SPIN/read_restart/log.11May18.spin.read_data.g++.1 rename to examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 index 405be50bd9..cc1cb29a6e 100644 --- a/examples/SPIN/read_restart/log.11May18.spin.read_data.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.1 @@ -1,4 +1,4 @@ -LAMMPS (11 May 2018) +LAMMPS (30 Oct 2019) units metal dimension 3 boundary p p p @@ -12,6 +12,7 @@ read_data Norm_randXY_8x8x32.data 1 by 1 by 1 MPI processor grid reading atoms ... 8192 atoms + read_data CPU = 0.0207078 secs mass 1 58.93 @@ -25,12 +26,12 @@ neigh_modify every 1 check no delay 0 fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # define outputs and computes -compute out_mag all compute/spin +compute out_mag all spin compute out_pe all pe compute out_ke all ke compute out_temp all temp @@ -45,7 +46,7 @@ thermo_style custom step time v_magnorm v_emag v_tmag temp etotal thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 10 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] run 100 Neighbor list info ... @@ -65,33 +66,33 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 18.68 | 18.68 | 18.68 Mbytes +Per MPI rank memory allocation (min/avg/max) = 19.68 | 19.68 | 19.68 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 0 0 0.980832325249102 -2984.9466433509 51.7121203365409 0 -38881.8459242429 - 10 0.001 0.980832325038224 -2984.94800197308 52.2550760237226 0.00128259392155095 -38881.8459243688 - 20 0.002 0.980832322622779 -2984.95196908579 53.4253029071033 0.0050206854169363 -38881.8459246487 - 30 0.003 0.980832317889283 -2984.95826684048 55.1488791221993 0.0109316238061975 -38881.8459250502 - 40 0.004 0.980832310888481 -2984.96649810512 57.3217709603901 0.0186091353316915 -38881.8459255204 - 50 0.005 0.980832301939686 -2984.97619813381 59.8271487572311 0.0275752699737783 -38881.8459260027 - 60 0.006 0.980832291654664 -2984.98688847988 62.5518654049861 0.0373348857300743 -38881.8459264498 - 70 0.007 0.980832280861627 -2984.99812400566 65.3978892661935 0.0474235455824994 -38881.845926824 - 80 0.008 0.980832270462785 -2985.00952679611 68.286219599829 0.0574425858114516 -38881.8459271072 - 90 0.009 0.980832261284587 -2985.02080458573 71.1539714621652 0.0670788260497413 -38881.8459272915 - 100 0.01 0.980832253960703 -2985.03175506188 73.9486358176052 0.0761100787140068 -38881.8459273845 -Loop time of 12.4286 on 1 procs for 100 steps with 8192 atoms + 0 0 0.0177864461018737 -1323.65841279979 1274.398774669 0 -37220.5576936917 + 10 0.001 0.0177864363786085 -1323.66900862123 1270.76616762926 0.0100007025152235 -37220.5576943558 + 20 0.002 0.0177864377251544 -1323.70032173151 1259.90270462032 0.0394803272360477 -37220.5576959255 + 30 0.003 0.0177864511986563 -1323.75117991179 1243.50772254923 0.0871132837928349 -37220.5576982168 + 40 0.004 0.0177864729727686 -1323.81992477224 1223.91535595806 0.150986538096776 -37220.5577010151 + 50 0.005 0.017786495620418 -1323.90456907402 1203.45497846157 0.22877054554493 -37220.5577041158 + 60 0.006 0.0177865119365897 -1324.00293472823 1183.95496070422 0.317876389336898 -37220.5577073311 + 70 0.007 0.0177865186121948 -1324.11277680481 1166.52445270059 0.415601818818485 -37220.5577104779 + 80 0.008 0.0177865171615599 -1324.23190710734 1151.59958937508 0.519276751090729 -37220.5577133816 + 90 0.009 0.0177865117923882 -1324.35831839963 1139.14485136813 0.626407059487507 -37220.5577158996 + 100 0.01 0.0177865063215865 -1324.49029089774 1128.88117273962 0.734797362055872 -37220.5577179524 +Loop time of 17.5042 on 1 procs for 100 steps with 8192 atoms -Performance: 0.070 ns/day, 345.239 hours/ns, 8.046 timesteps/s -99.6% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 0.049 ns/day, 486.227 hours/ns, 5.713 timesteps/s +99.7% CPU use with 1 MPI tasks x no OpenMP threads MPI task timing breakdown: Section | min time | avg time | max time |%varavg| %total --------------------------------------------------------------- -Pair | 4.0123 | 4.0123 | 4.0123 | 0.0 | 32.28 -Neigh | 3.005 | 3.005 | 3.005 | 0.0 | 24.18 -Comm | 0.041798 | 0.041798 | 0.041798 | 0.0 | 0.34 -Output | 1.8465 | 1.8465 | 1.8465 | 0.0 | 14.86 -Modify | 3.5157 | 3.5157 | 3.5157 | 0.0 | 28.29 -Other | | 0.007261 | | | 0.06 +Pair | 5.4555 | 5.4555 | 5.4555 | 0.0 | 31.17 +Neigh | 3.9944 | 3.9944 | 3.9944 | 0.0 | 22.82 +Comm | 0.086468 | 0.086468 | 0.086468 | 0.0 | 0.49 +Output | 2.7685 | 2.7685 | 2.7685 | 0.0 | 15.82 +Modify | 5.1645 | 5.1645 | 5.1645 | 0.0 | 29.50 +Other | | 0.0349 | | | 0.20 Nlocal: 8192 ave 8192 max 8192 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -109,4 +110,4 @@ Dangerous builds not checked Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:12 +Total wall time: 0:00:17 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 new file mode 100644 index 0000000000..8c477e633f --- /dev/null +++ b/examples/SPIN/read_restart/log.19Nov19.spin.read_data.g++.4 @@ -0,0 +1,113 @@ +LAMMPS (30 Oct 2019) +units metal +dimension 3 +boundary p p p + +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array +read_data Norm_randXY_8x8x32.data + orthogonal box = (0 0 0) to (28.32 28.32 113.28) + 1 by 1 by 4 MPI processor grid + reading atoms ... + 8192 atoms + read_data CPU = 0.023248 secs + +mass 1 58.93 + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 0.0446928 0.003496 1.4885 + +neighbor 1.0 bin +neigh_modify every 1 check no delay 0 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# define outputs and computes + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 10 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check no + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 7.49954 + ghost atom cutoff = 7.49954 + binsize = 3.74977, bins = 8 8 31 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 8.422 | 8.508 | 8.751 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0177864461018739 -1323.65841279979 1274.398774669 0 -37220.5576936996 + 10 0.001 0.0177864050983603 -1323.66900862096 1270.76618998865 0.0100007022583634 -37220.5576943555 + 20 0.002 0.0177863936833753 -1323.70032172864 1259.90276925185 0.0394803245313843 -37220.5576959254 + 30 0.003 0.0177864120892274 -1323.75117990111 1243.50783331745 0.087113273744231 -37220.5576982173 + 40 0.004 0.0177864533855652 -1323.8199247464 1223.91551103958 0.150986513868405 -37220.557701015 + 50 0.005 0.0177865078997919 -1323.90456902433 1203.45516787752 0.228770499151177 -37220.5577041159 + 60 0.006 0.0177865576955448 -1324.0029346455 1183.95517338662 0.317876312538184 -37220.5577073314 + 70 0.007 0.0177865860816348 -1324.11277667948 1166.52467969539 0.415601703342581 -37220.5577104775 + 80 0.008 0.0177865881669081 -1324.23190693081 1151.59982868413 0.519276589926842 -37220.557713381 + 90 0.009 0.0177865780982769 -1324.35831816525 1139.14509878533 0.626406847905203 -37220.557715901 + 100 0.01 0.017786564605084 -1324.49029060173 1128.88143013641 0.734797098519806 -37220.557717952 +Loop time of 7.30477 on 4 procs for 100 steps with 8192 atoms + +Performance: 0.118 ns/day, 202.910 hours/ns, 13.690 timesteps/s +98.0% 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.9727 | 2.0433 | 2.1095 | 3.9 | 27.97 +Neigh | 1.1665 | 1.3031 | 1.4137 | 8.7 | 17.84 +Comm | 0.15743 | 0.31703 | 0.53111 | 28.2 | 4.34 +Output | 1.0547 | 1.0747 | 1.094 | 1.4 | 14.71 +Modify | 2.5296 | 2.5551 | 2.5794 | 1.1 | 34.98 +Other | | 0.01167 | | | 0.16 + +Nlocal: 2048 ave 2061 max 2035 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Nghost: 5765 ave 5778 max 5752 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +Neighs: 143360 ave 144262 max 142469 min +Histogram: 1 0 0 1 0 0 1 0 0 1 +FullNghs: 286720 ave 288540 max 284900 min +Histogram: 1 0 0 1 0 0 1 0 0 1 + +Total # of neighbors = 1146880 +Ave neighs/atom = 140 +Neighbor list builds = 100 +Dangerous builds not checked + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:07 diff --git a/examples/SPIN/read_restart/log.11May18.spin.restart.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 similarity index 54% rename from examples/SPIN/read_restart/log.11May18.spin.restart.g++.1 rename to examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 index 16eb7c3f5e..4ca29113d3 100644 --- a/examples/SPIN/read_restart/log.11May18.spin.restart.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.1 @@ -1,4 +1,4 @@ -LAMMPS (11 May 2018) +LAMMPS (30 Oct 2019) # start a spin-lattice simulation from a data file units metal atom_style spin @@ -10,11 +10,13 @@ boundary p p p atom_modify map array read_restart restart_hcp_cobalt.equil +WARNING: Restart file used different # of processors: 4 vs. 1 (../read_restart.cpp:742) restoring atom style spin from restart orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 1 by 1 MPI processor grid restoring pair style spin/exchange from restart 500 atoms + read_restart CPU = 0.000402927 secs # setting mass, mag. moments, and interactions @@ -30,12 +32,12 @@ neigh_modify every 1 check no delay 0 fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 fix 2 all langevin/spin 0.0 0.0 21 -fix 3 all nve/spin lattice yes +fix 3 all nve/spin lattice moving timestep 0.0001 # define outputs -compute out_mag all compute/spin +compute out_mag all spin compute out_pe all pe compute out_ke all ke compute out_temp all temp @@ -70,33 +72,33 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 6.315 | 6.315 | 6.315 Mbytes +Per MPI rank memory allocation (min/avg/max) = 6.816 | 6.816 | 6.816 Mbytes Step Time v_magnorm v_emag v_tmag Temp TotEng - 1000 0 0.106120063678768 -11.8110267448938 5244.87332482316 0 -2206.81097898043 - 1010 0.001 0.106120047478105 -11.8198467887534 5263.87502105137 0.136650312456579 -2206.81097929055 - 1020 0.002 0.106120026430373 -11.8460960518731 5267.29822866382 0.542282409605327 -2206.81098022997 - 1030 0.003 0.106120005015917 -11.8891434078861 5252.95323564256 1.204018338139 -2206.81098172551 - 1040 0.004 0.106119988532653 -11.9479778701641 5220.88508622311 2.10120884995911 -2206.81098371047 - 1050 0.005 0.10611998133687 -12.021242685853 5172.58549378915 3.20622445795757 -2206.81098610701 - 1060 0.006 0.10611998489458 -12.107271344148 5110.57395203849 4.48535975411235 -2206.81098879725 - 1070 0.007 0.106119996964771 -12.204156761765 5038.48903231346 5.9003121044977 -2206.81099161183 - 1080 0.008 0.106120013042521 -12.3098695046152 4961.0327167967 7.4104497466856 -2206.81099434653 - 1090 0.009 0.106120029236234 -12.4224157835754 4883.3210922213 8.97568980540163 -2206.81099680117 - 1100 0.01 0.106120044071404 -12.5400036896932 4809.88136080052 10.559459821976 -2206.81099883104 -Loop time of 0.833234 on 1 procs for 100 steps with 500 atoms + 1000 0 0.108317262557656 -10.7649197733649 2538.4247868621 0 -2205.7648720089 + 1010 0.001 0.108317281393701 -10.7743543303502 2527.22692799144 0.146167392153018 -2205.76487255098 + 1020 0.002 0.108317318482233 -10.8022550516195 2509.47863584151 0.577304300153637 -2205.76487378396 + 1030 0.003 0.108317366763426 -10.8476659807571 2487.5614649682 1.27529086243277 -2205.76487555634 + 1040 0.004 0.108317415532953 -10.9092708333549 2463.97963921611 2.21443906326453 -2205.76487769286 + 1050 0.005 0.108317453851058 -10.98553406179 2440.70473642157 3.36396898978859 -2205.7648800529 + 1060 0.006 0.108317473584086 -11.0748008072977 2418.66477599297 4.68991434259399 -2205.76488256723 + 1070 0.007 0.108317471632913 -11.175325501803 2397.59274785581 6.15596240129541 -2205.76488520043 + 1080 0.008 0.108317450667394 -11.2852665400894 2376.32871275528 7.7237909750654 -2205.76488786887 + 1090 0.009 0.108317417687893 -11.4027246787047 2353.52646917989 9.35409156720424 -2205.76489041327 + 1100 0.01 0.108317381194814 -11.52585602487 2328.41541723561 11.0087303030003 -2205.76489265824 +Loop time of 1.05153 on 1 procs for 100 steps with 500 atoms -Performance: 1.037 ns/day, 23.145 hours/ns, 120.014 timesteps/s +Performance: 0.822 ns/day, 29.209 hours/ns, 95.100 timesteps/s 99.7% 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.26558 | 0.26558 | 0.26558 | 0.0 | 31.87 -Neigh | 0.21352 | 0.21352 | 0.21352 | 0.0 | 25.62 -Comm | 0.0057988 | 0.0057988 | 0.0057988 | 0.0 | 0.70 -Output | 0.12463 | 0.12463 | 0.12463 | 0.0 | 14.96 -Modify | 0.22275 | 0.22275 | 0.22275 | 0.0 | 26.73 -Other | | 0.0009537 | | | 0.11 +Pair | 0.3348 | 0.3348 | 0.3348 | 0.0 | 31.84 +Neigh | 0.26691 | 0.26691 | 0.26691 | 0.0 | 25.38 +Comm | 0.007993 | 0.007993 | 0.007993 | 0.0 | 0.76 +Output | 0.14892 | 0.14892 | 0.14892 | 0.0 | 14.16 +Modify | 0.29137 | 0.29137 | 0.29137 | 0.0 | 27.71 +Other | | 0.001526 | | | 0.15 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -114,4 +116,4 @@ Dangerous builds not checked Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:00 +Total wall time: 0:00:01 diff --git a/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 new file mode 100644 index 0000000000..5d40efc29b --- /dev/null +++ b/examples/SPIN/read_restart/log.19Nov19.spin.restart.g++.4 @@ -0,0 +1,118 @@ +LAMMPS (30 Oct 2019) +# start a spin-lattice simulation from a data file +units metal +atom_style spin + +dimension 3 +boundary p p p + +# necessary for the serial algorithm (sametag) +atom_modify map array + +read_restart restart_hcp_cobalt.equil + restoring atom style spin from restart + orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) + 1 by 2 by 2 MPI processor grid + restoring pair style spin/exchange from restart + 500 atoms + read_restart CPU = 0.000858784 secs + +# setting mass, mag. moments, and interactions + +mass 1 58.93 + +pair_style hybrid/overlay eam/alloy spin/exchange 4.0 +pair_coeff * * eam/alloy Co_PurjaPun_2012.eam.alloy Co +pair_coeff * * spin/exchange exchange 4.0 0.3593 1.135028015e-05 1.064568567 + +neighbor 1.0 bin +neigh_modify every 1 check no delay 0 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 +fix 2 all langevin/spin 0.0 0.0 21 + +fix 3 all nve/spin lattice moving +timestep 0.0001 + +# define outputs + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 10 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 100 all custom 1 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +run 100 +Neighbor list info ... + update every 1 steps, delay 0 steps, check no + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 7.49954 + ghost atom cutoff = 7.49954 + binsize = 3.74977, bins = 4 6 6 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair eam/alloy, perpetual, half/full from (2) + attributes: half, newton on + pair build: halffull/newton + stencil: none + bin: none + (2) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 6.704 | 6.704 | 6.704 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 1000 0 0.108317262557656 -10.7649197733649 2538.4247868621 0 -2205.7648720085 + 1010 0.001 0.108317290362529 -10.7743543303489 2527.22680531097 0.146167392137698 -2205.76487255096 + 1020 0.002 0.108317316207642 -10.8022550521284 2509.47840782645 0.577304308061779 -2205.76487378396 + 1030 0.003 0.108317335980455 -10.8476659832667 2487.56119588937 1.27529090130452 -2205.76487555634 + 1040 0.004 0.108317347902639 -10.9092708400684 2463.97936529674 2.21443916694928 -2205.76487769286 + 1050 0.005 0.108317349786635 -10.9855340757384 2440.7044253165 3.36396920446814 -2205.76488005291 + 1060 0.006 0.108317342445881 -11.0748008315013 2418.66438763214 4.68991471343994 -2205.76488256723 + 1070 0.007 0.10831733355314 -11.1753255362286 2397.59228728929 6.15596292529133 -2205.76488520046 + 1080 0.008 0.108317320750099 -11.2852665775656 2376.32820919279 7.7237915384778 -2205.76488786888 + 1090 0.009 0.108317304079233 -11.402724701646 2353.52588586648 9.35409189724323 -2205.7648904133 + 1100 0.01 0.108317284409678 -11.5258560062539 2328.41472376239 11.0087299868288 -2205.76489265829 +Loop time of 0.603216 on 4 procs for 100 steps with 500 atoms + +Performance: 1.432 ns/day, 16.756 hours/ns, 165.778 timesteps/s +99.9% 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.1203 | 0.12952 | 0.13546 | 1.6 | 21.47 +Neigh | 0.064357 | 0.080477 | 0.093005 | 4.4 | 13.34 +Comm | 0.016533 | 0.035739 | 0.06195 | 9.9 | 5.92 +Output | 0.063324 | 0.065044 | 0.066794 | 0.5 | 10.78 +Modify | 0.29023 | 0.29189 | 0.29336 | 0.3 | 48.39 +Other | | 0.0005503 | | | 0.09 + +Nlocal: 125 ave 127 max 122 min +Histogram: 1 0 0 0 1 0 0 0 0 2 +Nghost: 1387 ave 1390 max 1385 min +Histogram: 2 0 0 0 0 0 1 0 0 1 +Neighs: 9125 ave 9272 max 8945 min +Histogram: 1 0 0 1 0 0 0 0 1 1 +FullNghs: 18250 ave 18542 max 17812 min +Histogram: 1 0 0 0 1 0 0 0 0 2 + +Total # of neighbors = 73000 +Ave neighs/atom = 146 +Neighbor list builds = 100 +Dangerous builds not checked + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:00 diff --git a/examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.1 b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 similarity index 64% rename from examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.1 rename to examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 index c3be90cb50..986f93e3e1 100644 --- a/examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.1 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.1 @@ -1,4 +1,4 @@ -LAMMPS (11 May 2018) +LAMMPS (30 Oct 2019) # fcc cobalt in a 3d periodic box units metal @@ -18,7 +18,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 1 by 1 MPI processor grid create_atoms 1 box Created 500 atoms - Time spent = 0.00027585 secs + create_atoms CPU = 0.001122 secs # setting mass, mag. moments, and interactions for cobalt @@ -36,12 +36,12 @@ neigh_modify every 10 check yes delay 20 fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 fix 2 all langevin/spin 100.0 0.01 21 -fix 3 all nve/spin lattice no +fix 3 all nve/spin lattice frozen timestep 0.0001 # compute and output options -compute out_mag all compute/spin +compute out_mag all spin compute out_pe all pe compute out_ke all ke compute out_temp all temp @@ -70,33 +70,33 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 6.446 | 6.446 | 6.446 Mbytes +Per MPI rank memory allocation (min/avg/max) = 6.947 | 6.947 | 6.947 Mbytes Step Time v_magnorm v_emag Temp TotEng 0 0 0.076558814 1.7982359 0 1.7982359 - 100 0.01 0.079107243 0.56368447 0 0.56368447 - 200 0.02 0.08225862 -0.42421042 0 -0.42421042 - 300 0.03 0.08397714 -1.4964948 0 -1.4964948 - 400 0.04 0.084704989 -2.6740652 0 -2.6740652 - 500 0.05 0.087486342 -4.2043382 0 -4.2043382 - 600 0.06 0.09187261 -5.6687169 0 -5.6687169 - 700 0.07 0.096925249 -6.937499 0 -6.937499 - 800 0.08 0.098988236 -8.2456715 0 -8.2456715 - 900 0.09 0.10434092 -10.111953 0 -10.111953 - 1000 0.1 0.10612006 -11.811027 0 -11.811027 -Loop time of 2.60215 on 1 procs for 1000 steps with 500 atoms + 100 0.01 0.077628154 0.73387834 0 0.73387834 + 200 0.02 0.076678996 -0.4048463 0 -0.4048463 + 300 0.03 0.079174837 -1.3519103 0 -1.3519103 + 400 0.04 0.085031632 -3.0345702 0 -3.0345702 + 500 0.05 0.08702747 -4.0853256 0 -4.0853256 + 600 0.06 0.087066482 -5.259549 0 -5.259549 + 700 0.07 0.089788894 -6.629076 0 -6.629076 + 800 0.08 0.091699611 -8.0574087 0 -8.0574087 + 900 0.09 0.090038899 -9.2012019 0 -9.2012019 + 1000 0.1 0.093257309 -10.470452 0 -10.470452 +Loop time of 3.56687 on 1 procs for 1000 steps with 500 atoms -Performance: 3.320 ns/day, 7.228 hours/ns, 384.297 timesteps/s -99.0% CPU use with 1 MPI tasks x no OpenMP threads +Performance: 2.422 ns/day, 9.908 hours/ns, 280.358 timesteps/s +99.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 | 0.35178 | 0.35178 | 0.35178 | 0.0 | 13.52 +Pair | 0.46568 | 0.46568 | 0.46568 | 0.0 | 13.06 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.014421 | 0.014421 | 0.014421 | 0.0 | 0.55 -Output | 1.2046 | 1.2046 | 1.2046 | 0.0 | 46.29 -Modify | 1.0274 | 1.0274 | 1.0274 | 0.0 | 39.48 -Other | | 0.004006 | | | 0.15 +Comm | 0.022188 | 0.022188 | 0.022188 | 0.0 | 0.62 +Output | 1.4417 | 1.4417 | 1.4417 | 0.0 | 40.42 +Modify | 1.6335 | 1.6335 | 1.6335 | 0.0 | 45.80 +Other | | 0.003845 | | | 0.11 Nlocal: 500 ave 500 max 500 min Histogram: 1 0 0 0 0 0 0 0 0 0 @@ -116,4 +116,4 @@ write_restart restart_hcp_cobalt.equil Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:02 +Total wall time: 0:00:03 diff --git a/examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.4 b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 similarity index 64% rename from examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.4 rename to examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 index e54299b9dd..05f6091f79 100644 --- a/examples/SPIN/read_restart/log.11May18.spin.write_restart.g++.4 +++ b/examples/SPIN/read_restart/log.19Nov19.spin.write_restart.g++.4 @@ -1,4 +1,4 @@ -LAMMPS (11 May 2018) +LAMMPS (30 Oct 2019) # fcc cobalt in a 3d periodic box units metal @@ -18,7 +18,7 @@ Created orthogonal box = (0 0 0) to (12.5355 21.7121 20.4704) 1 by 2 by 2 MPI processor grid create_atoms 1 box Created 500 atoms - Time spent = 0.000257969 secs + create_atoms CPU = 0.000901937 secs # setting mass, mag. moments, and interactions for cobalt @@ -36,12 +36,12 @@ neigh_modify every 10 check yes delay 20 fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 fix 2 all langevin/spin 100.0 0.01 21 -fix 3 all nve/spin lattice no +fix 3 all nve/spin lattice frozen timestep 0.0001 # compute and output options -compute out_mag all compute/spin +compute out_mag all spin compute out_pe all pe compute out_ke all ke compute out_temp all temp @@ -70,33 +70,33 @@ Neighbor list info ... pair build: full/bin/atomonly stencil: full/bin/3d bin: standard -Per MPI rank memory allocation (min/avg/max) = 6.367 | 6.367 | 6.367 Mbytes +Per MPI rank memory allocation (min/avg/max) = 6.868 | 6.868 | 6.868 Mbytes Step Time v_magnorm v_emag Temp TotEng 0 0 0.076558814 1.7982359 0 1.7982359 - 100 0.01 0.081414414 0.70545723 0 0.70545723 - 200 0.02 0.084519539 -0.33171078 0 -0.33171078 - 300 0.03 0.089334139 -1.3988283 0 -1.3988283 - 400 0.04 0.092873722 -2.8519371 0 -2.8519371 - 500 0.05 0.0970839 -4.1531164 0 -4.1531164 - 600 0.06 0.099626132 -5.7993765 0 -5.7993765 - 700 0.07 0.10467169 -7.3011333 0 -7.3011333 - 800 0.08 0.10893493 -8.6918141 0 -8.6918141 - 900 0.09 0.11389657 -10.236174 0 -10.236174 - 1000 0.1 0.1180057 -11.896933 0 -11.896933 -Loop time of 1.05012 on 4 procs for 1000 steps with 500 atoms + 100 0.01 0.078299981 0.88259584 0 0.88259584 + 200 0.02 0.081260508 -0.43484722 0 -0.43484722 + 300 0.03 0.081195603 -1.7408209 0 -1.7408209 + 400 0.04 0.087298495 -3.4139038 0 -3.4139038 + 500 0.05 0.087663924 -4.3766089 0 -4.3766089 + 600 0.06 0.091713683 -5.8534921 0 -5.8534921 + 700 0.07 0.093779119 -6.706628 0 -6.706628 + 800 0.08 0.097960611 -7.8688568 0 -7.8688568 + 900 0.09 0.10193463 -9.5888008 0 -9.5888008 + 1000 0.1 0.10831726 -10.76492 0 -10.76492 +Loop time of 2.36594 on 4 procs for 1000 steps with 500 atoms -Performance: 8.228 ns/day, 2.917 hours/ns, 952.272 timesteps/s -98.1% CPU use with 4 MPI tasks x no OpenMP threads +Performance: 3.652 ns/day, 6.572 hours/ns, 422.665 timesteps/s +98.9% 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.08972 | 0.090456 | 0.091872 | 0.3 | 8.61 +Pair | 0.13515 | 0.15276 | 0.16507 | 2.8 | 6.46 Neigh | 0 | 0 | 0 | 0.0 | 0.00 -Comm | 0.016958 | 0.018047 | 0.019791 | 0.8 | 1.72 -Output | 0.36286 | 0.37483 | 0.38975 | 1.6 | 35.69 -Modify | 0.55131 | 0.56541 | 0.57702 | 1.3 | 53.84 -Other | | 0.001374 | | | 0.13 +Comm | 0.08478 | 0.10161 | 0.12408 | 4.5 | 4.29 +Output | 0.50658 | 0.52938 | 0.55066 | 2.3 | 22.38 +Modify | 1.5629 | 1.5794 | 1.6014 | 1.3 | 66.75 +Other | | 0.002834 | | | 0.12 Nlocal: 125 ave 125 max 125 min Histogram: 4 0 0 0 0 0 0 0 0 0 @@ -116,4 +116,4 @@ write_restart restart_hcp_cobalt.equil Please see the log.cite file for references relevant to this simulation -Total wall time: 0:00:01 +Total wall time: 0:00:02 diff --git a/examples/SPIN/run_spin_examples.sh b/examples/SPIN/run_spin_examples.sh new file mode 100755 index 0000000000..a71da82a04 --- /dev/null +++ b/examples/SPIN/run_spin_examples.sh @@ -0,0 +1,120 @@ +#!/bin/bash + +DATE=19Nov19 + +# bfo +cd bfo/ +../../../src/lmp_serial -in in.spin.bfo +cp log.lammps log.${DATE}.spin.bfo.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.bfo +cp log.lammps log.${DATE}.spin.bfo.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# fcc cobalt +cd cobalt_fcc/ +../../../src/lmp_serial -in in.spin.cobalt_fcc +cp log.lammps log.${DATE}.spin.cobalt_fcc.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.cobalt_fcc +cp log.lammps log.${DATE}.spin.cobalt_fcc.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# hcp cobalt +cd cobalt_hcp/ +../../../src/lmp_serial -in in.spin.cobalt_hcp +cp log.lammps log.${DATE}.spin.cobalt_hcp.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.cobalt_hcp +cp log.lammps log.${DATE}.spin.cobalt_hcp.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# dipole spin +cd dipole_spin/ +../../../src/lmp_serial -in in.spin.iron_dipole_cut +cp log.lammps log.${DATE}.spin.iron_dipole_cut.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron_dipole_cut +cp log.lammps log.${DATE}.spin.iron_dipole_cut.g++.4 +../../../src/lmp_serial -in in.spin.iron_dipole_ewald +cp log.lammps log.${DATE}.spin.iron_dipole_ewald.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron_dipole_ewald +cp log.lammps log.${DATE}.spin.iron_dipole_ewald.g++.4 +../../../src/lmp_serial -in in.spin.iron_dipole_pppm +cp log.lammps log.${DATE}.spin.iron_dipole_pppm.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron_dipole_pppm +cp log.lammps log.${DATE}.spin.iron_dipole_pppm.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# bcc iron +cd iron/ +../../../src/lmp_serial -in in.spin.iron +cp log.lammps log.${DATE}.spin.iron.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron +cp log.lammps log.${DATE}.spin.iron.g++.4 +../../../src/lmp_serial -in in.spin.iron_cubic +cp log.lammps log.${DATE}.spin.iron_cubic.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron_cubic +cp log.lammps log.${DATE}.spin.iron_cubic.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# fcc nickel +cd nickel/ +../../../src/lmp_serial -in in.spin.nickel +cp log.lammps log.${DATE}.spin.nickel.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.nickel +cp log.lammps log.${DATE}.spin.nickel.g++.4 +../../../src/lmp_serial -in in.spin.nickel_cubic +cp log.lammps log.${DATE}.spin.nickel_cubic.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.nickel_cubic +cp log.lammps log.${DATE}.spin.nickel_cubic.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# read restart +cd read_restart/ +../../../src/lmp_serial -in in.spin.write_restart +cp log.lammps log.${DATE}.spin.write_restart.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.write_restart +cp log.lammps log.${DATE}.spin.write_restart.g++.4 +../../../src/lmp_serial -in in.spin.restart +cp log.lammps log.${DATE}.spin.restart.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.restart +cp log.lammps log.${DATE}.spin.restart.g++.4 +../../../src/lmp_serial -in in.spin.read_data +cp log.lammps log.${DATE}.spin.read_data.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.read_data +cp log.lammps log.${DATE}.spin.read_data.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# setforce +cd setforce_spin/ +../../../src/lmp_serial -in in.spin.setforce +cp log.lammps log.${DATE}.spin.setforce.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.setforce +cp log.lammps log.${DATE}.spin.setforce.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. + +# spin minimizers +cd spinmin/ +../../../src/lmp_serial -in in.spin.bfo_min +cp log.lammps log.${DATE}.spin.bfo_min.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.bfo_min +cp log.lammps log.${DATE}.spin.bfo_min.g++.4 +../../../src/lmp_serial -in in.spin.bfo_min_cg +cp log.lammps log.${DATE}.spin.bfo_min_cg.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.bfo_min_cg +cp log.lammps log.${DATE}.spin.bfo_min_cg.g++.4 +../../../src/lmp_serial -in in.spin.bfo_min_lbfgs +cp log.lammps log.${DATE}.spin.bfo_min_lbfgs.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.bfo_min_lbfgs +cp log.lammps log.${DATE}.spin.bfo_min_lbfgs.g++.4 +../../../src/lmp_serial -in in.spin.iron_min +cp log.lammps log.${DATE}.spin.iron_min.g++.1 +mpirun -np 4 ../../../src/lmp_mpi -in in.spin.iron_min +cp log.lammps log.${DATE}.spin.iron_min.g++.4 +rm log.lammps log.cite dump*.lammpstrj +cd .. diff --git a/examples/SPIN/setforce_spin/in.spinmin.setforce b/examples/SPIN/setforce_spin/in.spin.setforce similarity index 86% rename from examples/SPIN/setforce_spin/in.spinmin.setforce rename to examples/SPIN/setforce_spin/in.spin.setforce index 822768e0ef..0d65955a29 100644 --- a/examples/SPIN/setforce_spin/in.spinmin.setforce +++ b/examples/SPIN/setforce_spin/in.spin.setforce @@ -8,7 +8,7 @@ atom_style spin atom_modify map array lattice sc 3.0 -region box block 0.0 10.0 0.0 10.0 0.0 1.0 +region box block 0.0 10.0 0.0 10.0 0.0 4.0 create_box 2 box region reg1 block 0.0 10.0 0.0 5.0 0.0 1.0 region reg2 block 0.0 10.0 6.0 10.0 0.0 1.0 @@ -47,13 +47,13 @@ variable magnorm equal c_out_mag[4] variable emag equal c_out_mag[5] variable tmag equal c_out_mag[6] -thermo 1000 +thermo 100 thermo_style custom step time v_magx v_magz v_magnorm v_tmag etotal thermo_modify format float %20.15g compute outsp all property/atom spx spy spz sp fmx fmy fmz -dump 1 all custom 1000 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[5] c_outsp[6] c_outsp[7] +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[5] c_outsp[6] c_outsp[7] min_style spin min_modify alpha_damp 1.0 discrete_factor 20.0 -minimize 1.0e-16 1.0e-16 50000 1000 +minimize 1.0e-16 1.0e-16 1000 100 diff --git a/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 new file mode 100644 index 0000000000..da8e705204 --- /dev/null +++ b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.1 @@ -0,0 +1,141 @@ +LAMMPS (30 Oct 2019) + +units metal +dimension 3 +boundary f f f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.0 +Lattice spacing in x,y,z = 3 3 3 +region box block 0.0 10.0 0.0 10.0 0.0 4.0 +create_box 2 box +Created orthogonal box = (0 0 0) to (30 30 12) + 1 by 1 by 1 MPI processor grid +region reg1 block 0.0 10.0 0.0 5.0 0.0 1.0 +region reg2 block 0.0 10.0 6.0 10.0 0.0 1.0 +create_atoms 1 region reg1 +Created 120 atoms + create_atoms CPU = 0.000591993 secs +create_atoms 2 region reg2 +Created 80 atoms + create_atoms CPU = 2.19345e-05 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +mass 2 55.845 +set region reg1 spin 2.2 0.0 0.0 1.0 + 120 settings made for spin +set region reg2 spin/random 31 2.2 + 80 settings made for spin/random + +group fixed_spin region reg1 +120 atoms in group fixed_spin + +pair_style hybrid/overlay spin/exchange 3.1 spin/dmi 3.1 +pair_coeff * * spin/exchange exchange 3.1 -0.01593 0.06626915552 1.211 +pair_coeff * * spin/dmi dmi 3.1 0.12e-03 0.0 0.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 anisotropy 5e-05 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 fixed_spin setforce/spin 0.0 0.0 0.0 +fix 3 all langevin/spin 0.0 0.1 21 +fix 4 all nve/spin lattice frozen + +timestep 0.0001 + +compute out_mag all spin +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magx v_magz v_magnorm v_tmag etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 20.0 +minimize 1.0e-16 1.0e-16 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.2 + ghost atom cutoff = 3.2 + binsize = 1.6, bins = 19 19 8 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.215 | 7.215 | 7.215 Mbytes +Step Time v_magx v_magz v_magnorm v_tmag TotEng + 0 0 0.000143282585570239 0.615515043943419 0.615726279597251 21.735436446264 0.251043691626527 + 100 0.01 -0.00116085697754605 0.590264559350799 0.590315072966953 0.00283413081085227 0.0846048989956838 + 200 0.02 -0.00014757052323624 0.5896197627388 0.589686497206689 0.000451051163122381 0.0839054390713707 + 300 0.03 2.64982966536903e-05 0.590029694756149 0.590102003120244 5.22539631503911e-05 0.0838351677819021 + 400 0.04 1.77805448780044e-05 0.590195117338991 0.590268726215095 4.46490059775722e-06 0.0838382933245033 + 500 0.05 6.71566571038784e-06 0.590243842081075 0.590317756995865 3.63227563542099e-07 0.0838411433938002 + 600 0.06 2.24103407431009e-06 0.590257551861528 0.590331542128336 2.99360370345602e-08 0.0838420708305254 + 700 0.07 7.12179152899672e-07 0.5902614042958 0.590335413637883 2.51559188415894e-09 0.0838423375091772 + 800 0.08 2.20574733078571e-07 0.590262494529884 0.590336508799302 2.14455748236281e-10 0.0838424126463501 + 900 0.09 6.72564339382342e-08 0.590262805532644 0.590336821097688 1.84495767133404e-11 0.0838424338620733 + 1000 0.1 2.03001940418668e-08 0.590262894882646 0.590336910794094 1.5958531383517e-12 0.0838424398944954 +Loop time of 0.128906 on 1 procs for 1000 steps with 200 atoms + +98.9% CPU use with 1 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + 0.251043691627 0.0838424398641 0.0838424398945 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.11267 | 0.11267 | 0.11267 | 0.0 | 87.41 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.00012422 | 0.00012422 | 0.00012422 | 0.0 | 0.10 +Output | 0.0062549 | 0.0062549 | 0.0062549 | 0.0 | 4.85 +Modify | 0.0036588 | 0.0036588 | 0.0036588 | 0.0 | 2.84 +Other | | 0.006197 | | | 4.81 + +Nlocal: 200 ave 200 max 200 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: 0 ave 0 max 0 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +FullNghs: 920 ave 920 max 920 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 920 +Ave neighs/atom = 4.6 +Neighbor list builds = 0 +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/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 new file mode 100644 index 0000000000..4889232f9d --- /dev/null +++ b/examples/SPIN/setforce_spin/log.19Nov19.spin.setforce.g++.4 @@ -0,0 +1,141 @@ +LAMMPS (30 Oct 2019) + +units metal +dimension 3 +boundary f f f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.0 +Lattice spacing in x,y,z = 3 3 3 +region box block 0.0 10.0 0.0 10.0 0.0 4.0 +create_box 2 box +Created orthogonal box = (0 0 0) to (30 30 12) + 2 by 2 by 1 MPI processor grid +region reg1 block 0.0 10.0 0.0 5.0 0.0 1.0 +region reg2 block 0.0 10.0 6.0 10.0 0.0 1.0 +create_atoms 1 region reg1 +Created 120 atoms + create_atoms CPU = 0.000560045 secs +create_atoms 2 region reg2 +Created 80 atoms + create_atoms CPU = 0.000101089 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +mass 2 55.845 +set region reg1 spin 2.2 0.0 0.0 1.0 + 120 settings made for spin +set region reg2 spin/random 31 2.2 + 80 settings made for spin/random + +group fixed_spin region reg1 +120 atoms in group fixed_spin + +pair_style hybrid/overlay spin/exchange 3.1 spin/dmi 3.1 +pair_coeff * * spin/exchange exchange 3.1 -0.01593 0.06626915552 1.211 +pair_coeff * * spin/dmi dmi 3.1 0.12e-03 0.0 0.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin zeeman 0.0 0.0 0.0 1.0 anisotropy 5e-05 0.0 0.0 1.0 +fix_modify 1 energy yes +fix 2 fixed_spin setforce/spin 0.0 0.0 0.0 +fix 3 all langevin/spin 0.0 0.1 21 +fix 4 all nve/spin lattice frozen + +timestep 0.0001 + +compute out_mag all spin +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magx v_magz v_magnorm v_tmag etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 20.0 +minimize 1.0e-16 1.0e-16 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.2 + ghost atom cutoff = 3.2 + binsize = 1.6, bins = 19 19 8 + 2 neighbor lists, perpetual/occasional/extra = 2 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.2 | 7.2 | 7.2 Mbytes +Step Time v_magx v_magz v_magnorm v_tmag TotEng + 0 0 0.000143282585570239 0.615515043943419 0.615726279597251 21.735436446264 0.251043691626527 + 100 0.01 -0.00116085697754605 0.590264559350799 0.590315072966953 0.00283413081085227 0.0846048989956832 + 200 0.02 -0.000147570523236238 0.5896197627388 0.589686497206689 0.000451051163122381 0.0839054390713705 + 300 0.03 2.64982966536902e-05 0.59002969475615 0.590102003120244 5.22539631503911e-05 0.0838351677819014 + 400 0.04 1.77805448780033e-05 0.590195117338991 0.590268726215095 4.46490059775722e-06 0.0838382933245032 + 500 0.05 6.71566571038784e-06 0.590243842081075 0.590317756995865 3.63227563542099e-07 0.0838411433937997 + 600 0.06 2.2410340743112e-06 0.590257551861528 0.590331542128336 2.99360370345601e-08 0.0838420708305252 + 700 0.07 7.12179152897591e-07 0.5902614042958 0.590335413637884 2.51559188415894e-09 0.0838423375091767 + 800 0.08 2.20574733079126e-07 0.590262494529884 0.590336508799302 2.14455748236281e-10 0.0838424126463497 + 900 0.09 6.72564339365689e-08 0.590262805532644 0.590336821097688 1.84495767133404e-11 0.0838424338620728 + 1000 0.1 2.03001940390912e-08 0.590262894882646 0.590336910794094 1.5958531383517e-12 0.0838424398944951 +Loop time of 0.0892034 on 4 procs for 1000 steps with 200 atoms + +91.7% CPU use with 4 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + 0.251043691627 0.0838424398641 0.0838424398945 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.032445 | 0.038594 | 0.054315 | 4.6 | 43.27 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.020121 | 0.035668 | 0.042827 | 4.8 | 39.98 +Output | 0.0024662 | 0.0025705 | 0.0028648 | 0.3 | 2.88 +Modify | 0.00099444 | 0.0010954 | 0.0011995 | 0.2 | 1.23 +Other | | 0.01128 | | | 12.64 + +Nlocal: 50 ave 50 max 50 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 34.5 ave 48 max 22 min +Histogram: 1 0 0 0 2 0 0 0 0 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 230 ave 230 max 230 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 920 +Ave neighs/atom = 4.6 +Neighbor list builds = 0 +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/SPIN/spinmin/in.spinmin.bfo b/examples/SPIN/spinmin/in.spin.bfo_min similarity index 97% rename from examples/SPIN/spinmin/in.spinmin.bfo rename to examples/SPIN/spinmin/in.spin.bfo_min index 5ebc9e0afe..701e049de3 100644 --- a/examples/SPIN/spinmin/in.spinmin.bfo +++ b/examples/SPIN/spinmin/in.spin.bfo_min @@ -9,7 +9,7 @@ atom_style spin atom_modify map array lattice sc 3.96 -region box block 0.0 34.0 0.0 34.0 0.0 1.0 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 create_box 1 box create_atoms 1 box diff --git a/examples/SPIN/spinmin/in.spinmin_cg.bfo b/examples/SPIN/spinmin/in.spin.bfo_min_cg similarity index 94% rename from examples/SPIN/spinmin/in.spinmin_cg.bfo rename to examples/SPIN/spinmin/in.spin.bfo_min_cg index 9d57399a56..7ce29b35ab 100644 --- a/examples/SPIN/spinmin/in.spinmin_cg.bfo +++ b/examples/SPIN/spinmin/in.spin.bfo_min_cg @@ -9,7 +9,7 @@ atom_style spin atom_modify map array lattice sc 3.96 -region box block 0.0 34.0 0.0 34.0 0.0 1.0 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 create_box 1 box create_atoms 1 box @@ -51,4 +51,4 @@ dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3 min_style spin/cg # min_modify line spin_none discrete_factor 10.0 -minimize 1.0e-10 1.0e-10 10000 10000 +minimize 1.0e-10 1.0e-10 1000 100 diff --git a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo b/examples/SPIN/spinmin/in.spin.bfo_min_lbfgs similarity index 97% rename from examples/SPIN/spinmin/in.spinmin_lbfgs.bfo rename to examples/SPIN/spinmin/in.spin.bfo_min_lbfgs index 56cd6b8fae..055903ab04 100644 --- a/examples/SPIN/spinmin/in.spinmin_lbfgs.bfo +++ b/examples/SPIN/spinmin/in.spin.bfo_min_lbfgs @@ -52,4 +52,4 @@ dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3 min_style spin/lbfgs # min_modify line spin_cubic discrete_factor 10.0 min_modify norm max -minimize 1.0e-15 1.0e-10 10000 1000 +minimize 1.0e-15 1.0e-10 1000 100 diff --git a/examples/SPIN/spinmin/in.spinmin.iron b/examples/SPIN/spinmin/in.spin.iron_min similarity index 94% rename from examples/SPIN/spinmin/in.spinmin.iron rename to examples/SPIN/spinmin/in.spin.iron_min index ebbd229b89..9ed07eccc7 100644 --- a/examples/SPIN/spinmin/in.spinmin.iron +++ b/examples/SPIN/spinmin/in.spin.iron_min @@ -9,7 +9,7 @@ atom_style spin atom_modify map array lattice bcc 2.8665 -region box block 0.0 4.0 0.0 4.0 0.0 4.0 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 create_box 1 box create_atoms 1 box @@ -52,4 +52,4 @@ dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[ min_style spin min_modify alpha_damp 1.0 discrete_factor 10.0 -minimize 1.0e-10 1.0e-10 100000 1000 +minimize 1.0e-10 1.0e-10 1000 100 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 new file mode 100644 index 0000000000..134ff82ea0 --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.1 @@ -0,0 +1,148 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.00103712 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +#pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 0.001 0.0 0.0 1.0 anisotropy 0.01 1.0 0.0 0.0 +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 10.0 +minimize 1.0e-10 0.0 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 8.331 | 8.331 | 8.331 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0100717228668283 -0.162177519662199 14970.7090923449 0 -0.157514482753568 + 50 0.005 0.00013406177065452 -128.226118665465 0.102634444037433 0 -128.28618242467 + 100 0.01 7.67769618983783e-06 -131.374599259781 0.0222596977749883 0 -131.428418504308 + 150 0.015 6.02904602224617e-07 -132.224372015825 0.00974271828169067 0 -132.273190134603 + 200 0.02 6.50197247050607e-07 -132.573383315469 0.00374227079785919 0 -132.617565541035 + 250 0.025 4.40534385751331e-07 -132.729743470508 0.00193340972825779 0 -132.770567114743 + 300 0.03 2.78356316513452e-07 -132.819255077939 0.00124938353773497 0 -132.857574876413 + 350 0.035 1.79684785125462e-07 -132.882714312877 0.000973166792896161 0 -132.919261229743 + 400 0.04 1.10949878458879e-07 -132.935357748213 0.000852955460997589 0 -132.970786605995 + 450 0.045 6.49064465617783e-08 -132.982991683198 0.000790741148426227 0 -133.017887798926 + 500 0.05 3.70514666560433e-08 -133.027689959766 0.000747949132882749 0 -133.062561991888 + 550 0.055 2.12433814830335e-08 -133.070148920145 0.000712637321271171 0 -133.105417593747 + 600 0.06 1.24676590173818e-08 -133.110772798502 0.000685051841817329 0 -133.146767469277 + 650 0.065 7.53611859123344e-09 -133.150126417754 0.000669443562813207 0 -133.187094895709 + 700 0.07 4.63539338668379e-09 -133.189024073453 0.000669619853917951 0 -133.227152349437 + 750 0.075 2.82145833993213e-09 -133.22844627026 0.00068733803508696 0 -133.267881315199 + 800 0.08 1.64378151551878e-09 -133.269413776733 0.00072219769217513 0 -133.310284062462 + 850 0.085 8.88331010921243e-10 -133.312863108453 0.000771645398804489 0 -133.355293578462 + 900 0.09 4.33874801673642e-10 -133.359507749172 0.000830255722998153 0 -133.403626236688 + 950 0.095 1.88127849216404e-10 -133.409630495316 0.000888348219681115 0 -133.455560507802 + 1000 0.1 7.17748877096286e-11 -133.462806227865 0.000931427722404679 0 -133.510640942679 +Loop time of 11.213 on 1 procs for 1000 steps with 5780 atoms + +99.7% CPU use with 1 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.157514482754 -133.509516066 -133.510640943 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 10.611 | 10.611 | 10.611 | 0.0 | 94.63 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.048211 | 0.048211 | 0.048211 | 0.0 | 0.43 +Output | 0.37333 | 0.37333 | 0.37333 | 0.0 | 3.33 +Modify | 0.038759 | 0.038759 | 0.038759 | 0.0 | 0.35 +Other | | 0.1419 | | | 1.27 + +Nlocal: 5780 ave 5780 max 5780 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1065 ave 1065 max 1065 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: 92480 ave 92480 max 92480 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:11 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 new file mode 100644 index 0000000000..16e51bd17a --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min.g++.4 @@ -0,0 +1,148 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.00216103 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +#pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 0.001 0.0 0.0 1.0 anisotropy 0.01 1.0 0.0 0.0 +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 10.0 +minimize 1.0e-10 0.0 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.788 | 7.788 | 7.788 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0100717228668283 -0.162177519662199 14970.709092345 0 -0.157514482753586 + 50 0.005 0.000134061770654521 -128.226118665465 0.102634444037434 0 -128.286182424672 + 100 0.01 7.67769618983817e-06 -131.374599259781 0.0222596977749883 0 -131.428418504308 + 150 0.015 6.02904602224806e-07 -132.224372015825 0.00974271828169071 0 -132.273190134602 + 200 0.02 6.50197247050491e-07 -132.573383315469 0.00374227079785921 0 -132.617565541034 + 250 0.025 4.4053438575152e-07 -132.729743470508 0.0019334097282578 0 -132.770567114743 + 300 0.03 2.78356316513274e-07 -132.819255077939 0.00124938353773497 0 -132.857574876413 + 350 0.035 1.79684785125388e-07 -132.882714312877 0.000973166792896165 0 -132.919261229742 + 400 0.04 1.10949878459078e-07 -132.935357748213 0.000852955460997588 0 -132.970786605995 + 450 0.045 6.49064465617817e-08 -132.982991683198 0.000790741148426224 0 -133.017887798927 + 500 0.05 3.70514666559952e-08 -133.027689959766 0.00074794913288275 0 -133.06256199189 + 550 0.055 2.12433814830885e-08 -133.070148920145 0.00071263732127117 0 -133.105417593745 + 600 0.06 1.24676590171361e-08 -133.110772798503 0.000685051841817325 0 -133.14676746928 + 650 0.065 7.53611859129351e-09 -133.150126417754 0.000669443562813208 0 -133.187094895708 + 700 0.07 4.63539338651321e-09 -133.189024073453 0.000669619853917953 0 -133.227152349439 + 750 0.075 2.82145833974835e-09 -133.22844627026 0.000687338035086961 0 -133.267881315198 + 800 0.08 1.64378151566173e-09 -133.269413776733 0.000722197692175127 0 -133.310284062463 + 850 0.085 8.883310104497e-10 -133.312863108454 0.000771645398804486 0 -133.355293578462 + 900 0.09 4.33874801863461e-10 -133.359507749172 0.000830255722998156 0 -133.403626236688 + 950 0.095 1.8812784924272e-10 -133.409630495316 0.000888348219681112 0 -133.455560507802 + 1000 0.1 7.17748875671948e-11 -133.462806227865 0.000931427722404681 0 -133.510640942679 +Loop time of 3.46778 on 4 procs for 1000 steps with 5780 atoms + +99.2% CPU use with 4 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.157514482754 -133.509516066 -133.510640943 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 2.4063 | 2.831 | 3.0798 | 15.5 | 81.64 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.21179 | 0.45698 | 0.87844 | 38.4 | 13.18 +Output | 0.1139 | 0.11396 | 0.11409 | 0.0 | 3.29 +Modify | 0.0079708 | 0.0099814 | 0.011315 | 1.2 | 0.29 +Other | | 0.05581 | | | 1.61 + +Nlocal: 1445 ave 1445 max 1445 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 555 ave 555 max 555 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: 23120 ave 23120 max 23120 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:03 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 new file mode 100644 index 0000000000..0687081521 --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.1 @@ -0,0 +1,141 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.00103903 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +# pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/cg +# min_modify line spin_none discrete_factor 10.0 +minimize 1.0e-10 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Line search incompatible gneb (../min_spin_cg.cpp:105) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 8.331 | 8.331 | 8.331 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0100717228668283 -0.162177519662199 14970.7090923449 0 -0.157514482753568 + 100 0.01 8.97646420937928e-06 -132.756468673032 0.00226858475243124 0 -132.798812395869 + 200 0.02 5.70496744394871e-06 -133.065966570145 0.000924384747875191 0 -133.105411060402 + 300 0.03 7.08166486347207e-06 -133.359072681024 0.00128114254070689 0 -133.406669528642 + 400 0.04 4.6022497035281e-06 -133.668643035704 0.00082233479844806 0 -133.725353643023 + 500 0.05 3.13737045264263e-06 -133.819548711647 0.00036967841746145 0 -133.878037514586 + 600 0.06 2.55239214470191e-06 -133.889302880669 0.000169614248283497 0 -133.948327309748 + 700 0.07 1.92236411979773e-06 -133.920147501261 7.31985644003828e-05 0 -133.979597440787 + 800 0.08 1.40879742056288e-06 -133.933445418833 3.19349095035102e-05 0 -133.993344750158 + 900 0.09 1.02629246258505e-06 -133.939321574068 1.44399877051466e-05 0 -133.999611147323 + 1000 0.1 7.52253147839439e-07 -133.942032102451 6.85789018963958e-06 0 -134.002604512511 +Loop time of 10.4788 on 1 procs for 1000 steps with 5780 atoms + +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.157514482754 -134.00257032 -134.002604513 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 2.122e-314 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 9.7413 | 9.7413 | 9.7413 | 0.0 | 92.96 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.033583 | 0.033583 | 0.033583 | 0.0 | 0.32 +Output | 0.33068 | 0.33068 | 0.33068 | 0.0 | 3.16 +Modify | 0.033124 | 0.033124 | 0.033124 | 0.0 | 0.32 +Other | | 0.3401 | | | 3.25 + +Nlocal: 5780 ave 5780 max 5780 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 1065 ave 1065 max 1065 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: 92480 ave 92480 max 92480 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:10 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 new file mode 100644 index 0000000000..b1dfabd35e --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_cg.g++.4 @@ -0,0 +1,141 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 19.8) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 5780 atoms + create_atoms CPU = 0.000909805 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 5780 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +# pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/cg +# min_modify line spin_none discrete_factor 10.0 +minimize 1.0e-10 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Line search incompatible gneb (../min_spin_cg.cpp:105) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 7 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.788 | 7.788 | 7.788 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0100717228668283 -0.162177519662199 14970.709092345 0 -0.157514482753586 + 100 0.01 8.97646420936397e-06 -132.756468673032 0.00226858475243123 0 -132.79881239587 + 200 0.02 5.7049674439631e-06 -133.065966570145 0.000924384747875186 0 -133.105411060402 + 300 0.03 7.08166486348038e-06 -133.359072681024 0.00128114254070688 0 -133.406669528642 + 400 0.04 4.60224970353229e-06 -133.668643035703 0.000822334798448062 0 -133.725353643022 + 500 0.05 3.13737045264193e-06 -133.819548711647 0.000369678417461456 0 -133.878037514585 + 600 0.06 2.55239214469856e-06 -133.889302880669 0.0001696142482835 0 -133.948327309746 + 700 0.07 1.92236411979341e-06 -133.920147501261 7.31985644003847e-05 0 -133.979597440788 + 800 0.08 1.40879742055238e-06 -133.933445418833 3.19349095035109e-05 0 -133.993344750158 + 900 0.09 1.02629246257047e-06 -133.939321574068 1.44399877051467e-05 0 -133.999611147322 + 1000 0.1 7.52253147824893e-07 -133.942032102451 6.85789018963965e-06 0 -134.002604512509 +Loop time of 4.52508 on 4 procs for 1000 steps with 5780 atoms + +97.3% CPU use with 4 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.157514482754 -134.00257032 -134.002604513 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 2.7814 | 3.2998 | 3.808 | 25.6 | 72.92 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.37682 | 0.87552 | 1.3847 | 48.7 | 19.35 +Output | 0.1621 | 0.16349 | 0.16483 | 0.3 | 3.61 +Modify | 0.0099754 | 0.012567 | 0.014974 | 2.1 | 0.28 +Other | | 0.1737 | | | 3.84 + +Nlocal: 1445 ave 1445 max 1445 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 555 ave 555 max 555 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: 23120 ave 23120 max 23120 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 92480 +Ave neighs/atom = 16 +Neighbor list builds = 0 +Dangerous builds = 0 + +Please see the log.cite file for references relevant to this simulation + +Total wall time: 0:00:04 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 new file mode 100644 index 0000000000..b13ce090e4 --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.1 @@ -0,0 +1,139 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 1.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 3.96) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 1156 atoms + create_atoms CPU = 0.000702858 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 1156 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +#pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/lbfgs +# min_modify line spin_cubic discrete_factor 10.0 +min_modify norm max +minimize 1.0e-15 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Line search incompatible gneb (../min_spin_lbfgs.cpp:109) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 2 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.748 | 7.748 | 7.748 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0205636053306396 -0.217760509274283 1541.29975585881 0 -0.21723077139301 + 50 0.005 0.000966655616832908 -19.2878369426356 0.312860071233838 0 -19.3229939390148 + 100 0.01 0.00154452800146007 -19.5948898197921 0.365367666925721 0 -19.6389064900417 + 150 0.015 4.90329738897855e-05 -19.6962578948663 0.000386378108166462 0 -19.704713985757 + 200 0.02 1.39636819172648e-06 -19.6975289055185 6.05740522809686e-05 0 -19.7059135025107 + 250 0.025 7.30255912392386e-08 -19.6975359463778 7.86050372080572e-09 0 -19.7059189975433 + 300 0.03 2.3618265959146e-09 -19.6975359475117 1.36402599486317e-13 0 -19.70591910974 + 347 0.0347 1.42160367645076e-11 -19.6975359475123 2.85504863224395e-16 0 -19.7059191162178 +Loop time of 0.427798 on 1 procs for 347 steps with 1156 atoms + +99.9% CPU use with 1 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = force tolerance + Energy initial, next-to-last, final = + -0.217230771393 -19.7059191162 -19.7059191162 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 347 347 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.36166 | 0.36166 | 0.36166 | 0.0 | 84.54 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0016549 | 0.0016549 | 0.0016549 | 0.0 | 0.39 +Output | 0.02019 | 0.02019 | 0.02019 | 0.0 | 4.72 +Modify | 0.0024493 | 0.0024493 | 0.0024493 | 0.0 | 0.57 +Other | | 0.04184 | | | 9.78 + +Nlocal: 1156 ave 1156 max 1156 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 213 ave 213 max 213 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: 9248 ave 9248 max 9248 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 9248 +Ave neighs/atom = 8 +Neighbor list builds = 0 +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/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 new file mode 100644 index 0000000000..2a5917663e --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.bfo_min_lbfgs.g++.4 @@ -0,0 +1,139 @@ +LAMMPS (30 Oct 2019) +# bfo in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice sc 3.96 +Lattice spacing in x,y,z = 3.96 3.96 3.96 +region box block 0.0 34.0 0.0 34.0 0.0 1.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (134.64 134.64 3.96) + 2 by 2 by 1 MPI processor grid +create_atoms 1 box +Created 1156 atoms + create_atoms CPU = 0.000618935 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 1.0 +set group all spin/random 11 2.50 + 1156 settings made for spin/random + +pair_style hybrid/overlay spin/exchange 6.0 spin/magelec 4.5 spin/dmi 4.5 +pair_coeff * * spin/exchange exchange 6.0 -0.01575 0.0 1.965 +#pair_coeff * * spin/magelec magelec 4.5 0.000109 1.0 1.0 1.0 +pair_coeff * * spin/magelec magelec 4.5 0.00109 1.0 1.0 1.0 +pair_coeff * * spin/dmi dmi 4.5 0.00005 1.0 1.0 1.0 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +fix 1 all precession/spin anisotropy 0.0000033 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 50 +thermo_style custom step time v_magnorm v_emag v_tmag temp etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 50 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin/lbfgs +# min_modify line spin_cubic discrete_factor 10.0 +min_modify norm max +minimize 1.0e-15 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Line search incompatible gneb (../min_spin_lbfgs.cpp:109) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 6.1 + ghost atom cutoff = 6.1 + binsize = 3.05, bins = 45 45 2 + 3 neighbor lists, perpetual/occasional/extra = 3 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard + (2) pair spin/magelec, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none + (3) pair spin/dmi, perpetual, copy from (1) + attributes: full, newton on + pair build: copy + stencil: none + bin: none +Per MPI rank memory allocation (min/avg/max) = 7.619 | 7.619 | 7.619 Mbytes +Step Time v_magnorm v_emag v_tmag Temp TotEng + 0 0 0.0205636053306396 -0.217760509274282 1541.29975585882 0 -0.217230771393012 + 50 0.005 0.000966655616837406 -19.2878369426356 0.312860071233841 0 -19.3229939390148 + 100 0.01 0.00154452800191107 -19.5948898197917 0.365367666925029 0 -19.6389064900413 + 150 0.015 4.89955946750017e-05 -19.6962580067431 0.000385536538802408 0 -19.7047140195852 + 200 0.02 5.66300530875654e-05 -19.6975252647309 9.8679922880911e-05 0 -19.7059140354146 + 250 0.025 5.21141123128679e-08 -19.6975359469038 2.52554968535685e-09 0 -19.7059189333986 + 300 0.03 2.9845103782958e-09 -19.6975359475094 2.31782597655471e-11 0 -19.7059191124033 + 342 0.0342 1.0526549233076e-10 -19.6975359475123 3.65641352240487e-16 0 -19.7059191178145 +Loop time of 0.234594 on 4 procs for 342 steps with 1156 atoms + +93.1% CPU use with 4 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = force tolerance + Energy initial, next-to-last, final = + -0.217230771393 -19.7059191178 -19.7059191178 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 342 342 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.097515 | 0.12325 | 0.15193 | 7.4 | 52.54 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.038284 | 0.061142 | 0.081045 | 8.1 | 26.06 +Output | 0.008667 | 0.0086921 | 0.0087271 | 0.0 | 3.71 +Modify | 0.00063705 | 0.00084341 | 0.0010526 | 0.0 | 0.36 +Other | | 0.04067 | | | 17.34 + +Nlocal: 289 ave 289 max 289 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +Nghost: 111 ave 111 max 111 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: 2312 ave 2312 max 2312 min +Histogram: 4 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 9248 +Ave neighs/atom = 8 +Neighbor list builds = 0 +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/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 new file mode 100644 index 0000000000..637c624a7c --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.1 @@ -0,0 +1,126 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) + 1 by 1 by 1 MPI processor grid +create_atoms 1 box +Created 250 atoms + create_atoms CPU = 0.00061512 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin/random 31 2.2 + 250 settings made for spin/random +#set group all spin 2.2 1.0 1.0 -1.0 + +pair_style spin/exchange 3.5 +pair_coeff * * exchange 3.4 0.02726 0.2171 1.841 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 0.001 0.0 0.0 1.0 anisotropy 0.01 1.0 0.0 0.0 +fix 1 all precession/spin anisotropy 0.0001 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magx v_magz v_magnorm v_tmag etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 10.0 +minimize 1.0e-10 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.6 + ghost atom cutoff = 3.6 + binsize = 1.8, bins = 8 8 8 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 6.848 | 6.848 | 6.848 Mbytes +Step Time v_magx v_magz v_magnorm v_tmag TotEng + 0 0 -0.0285071136621457 -0.00948990815281275 0.0764569750905723 5048.56076237679 -0.701465876910694 + 100 0.01 -0.584953861980204 -0.0517163256267969 0.999992350892306 6.25556948778472e-05 -50.578744362023 + 200 0.02 -0.584864756506845 -0.0547143484057153 0.999999990495506 3.49782260454062e-06 -50.5787971409244 + 300 0.03 -0.5847600493607 -0.0578846348986585 0.999999999988174 3.83095226805016e-06 -50.5788061208586 + 400 0.04 -0.584642875238893 -0.0612373075362701 0.999999999999986 4.28575832708226e-06 -50.5788161053511 + 500 0.05 -0.584511765589529 -0.0647826190376231 1 4.79421486949086e-06 -50.5788272748485 + 600 0.06 -0.584365074206159 -0.0685313536438759 1 5.36242072641834e-06 -50.5788397688161 + 700 0.07 -0.584200963215273 -0.072494846958872 1 5.99725249459222e-06 -50.5788537427261 + 800 0.08 -0.584017381477007 -0.0766850043611195 0.999999999999999 6.70634191991825e-06 -50.5788693699026 + 900 0.09 -0.583812040722351 -0.0811143180675364 0.999999999999999 7.49814943594148e-06 -50.5788868434701 + 1000 0.1 -0.583582389243979 -0.0857958823565731 0.999999999999998 8.38204259112222e-06 -50.5789063784909 +Loop time of 0.215249 on 1 procs for 1000 steps with 250 atoms + +100.0% CPU use with 1 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.701465876911 -50.5789061722 -50.5789063785 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.19278 | 0.19278 | 0.19278 | 0.0 | 89.56 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.0062225 | 0.0062225 | 0.0062225 | 0.0 | 2.89 +Output | 0.0085046 | 0.0085046 | 0.0085046 | 0.0 | 3.95 +Modify | 0.0017273 | 0.0017273 | 0.0017273 | 0.0 | 0.80 +Other | | 0.006012 | | | 2.79 + +Nlocal: 250 ave 250 max 250 min +Histogram: 1 0 0 0 0 0 0 0 0 0 +Nghost: 315 ave 315 max 315 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: 3200 ave 3200 max 3200 min +Histogram: 1 0 0 0 0 0 0 0 0 0 + +Total # of neighbors = 3200 +Ave neighs/atom = 12.8 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 diff --git a/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 new file mode 100644 index 0000000000..70f395ab08 --- /dev/null +++ b/examples/SPIN/spinmin/log.19Nov19.spin.iron_min.g++.4 @@ -0,0 +1,126 @@ +LAMMPS (30 Oct 2019) +# bcc iron in a 3d periodic box + +units metal +dimension 3 +boundary p p f +atom_style spin + +# necessary for the serial algorithm (sametag) +atom_modify map array + +lattice bcc 2.8665 +Lattice spacing in x,y,z = 2.8665 2.8665 2.8665 +region box block 0.0 5.0 0.0 5.0 0.0 5.0 +create_box 1 box +Created orthogonal box = (0 0 0) to (14.3325 14.3325 14.3325) + 1 by 2 by 2 MPI processor grid +create_atoms 1 box +Created 250 atoms + create_atoms CPU = 0.000644922 secs + +# setting mass, mag. moments, and interactions for bcc iron + +mass 1 55.845 +set group all spin/random 31 2.2 + 250 settings made for spin/random +#set group all spin 2.2 1.0 1.0 -1.0 + +pair_style spin/exchange 3.5 +pair_coeff * * exchange 3.4 0.02726 0.2171 1.841 + +neighbor 0.1 bin +neigh_modify every 10 check yes delay 20 + +#fix 1 all precession/spin zeeman 0.001 0.0 0.0 1.0 anisotropy 0.01 1.0 0.0 0.0 +fix 1 all precession/spin anisotropy 0.0001 0.0 0.0 1.0 +fix_modify 1 energy yes + +timestep 0.0001 + +compute out_mag all spin +compute out_pe all pe +compute out_ke all ke +compute out_temp all temp + +variable magx equal c_out_mag[1] +variable magy equal c_out_mag[2] +variable magz equal c_out_mag[3] +variable magnorm equal c_out_mag[4] +variable emag equal c_out_mag[5] +variable tmag equal c_out_mag[6] + +thermo 100 +thermo_style custom step time v_magx v_magz v_magnorm v_tmag etotal +thermo_modify format float %20.15g + +compute outsp all property/atom spx spy spz sp fmx fmy fmz +dump 1 all custom 100 dump.lammpstrj type x y z c_outsp[1] c_outsp[2] c_outsp[3] c_outsp[4] c_outsp[5] c_outsp[6] c_outsp[7] + +min_style spin +min_modify alpha_damp 1.0 discrete_factor 10.0 +minimize 1.0e-10 1.0e-10 1000 100 +WARNING: Using 'neigh_modify every 1 delay 0 check yes' setting during minimization (../min.cpp:177) +WARNING: Using spin pair style without nve/spin or neb/spin (../pair_spin.cpp:87) +Neighbor list info ... + update every 1 steps, delay 0 steps, check yes + max neighbors/atom: 2000, page size: 100000 + master list distance cutoff = 3.6 + ghost atom cutoff = 3.6 + binsize = 1.8, bins = 8 8 8 + 1 neighbor lists, perpetual/occasional/extra = 1 0 0 + (1) pair spin/exchange, perpetual + attributes: full, newton on + pair build: full/bin/atomonly + stencil: full/bin/3d + bin: standard +Per MPI rank memory allocation (min/avg/max) = 6.828 | 6.829 | 6.829 Mbytes +Step Time v_magx v_magz v_magnorm v_tmag TotEng + 0 0 -0.0285071136621457 -0.00948990815281275 0.0764569750905723 5048.5607623768 -0.701465876910695 + 100 0.01 -0.584953861980204 -0.0517163256267969 0.999992350892306 6.25556948778489e-05 -50.5787443620229 + 200 0.02 -0.584864756506845 -0.0547143484057154 0.999999990495506 3.49782260454051e-06 -50.5787971409246 + 300 0.03 -0.5847600493607 -0.0578846348986585 0.999999999988173 3.83095226804998e-06 -50.5788061208592 + 400 0.04 -0.584642875238891 -0.06123730753627 0.999999999999984 4.28575832708228e-06 -50.5788161053499 + 500 0.05 -0.584511765589526 -0.0647826190376232 0.999999999999999 4.79421486949061e-06 -50.5788272748473 + 600 0.06 -0.584365074206158 -0.0685313536438759 0.999999999999999 5.36242072641826e-06 -50.5788397688148 + 700 0.07 -0.584200963215272 -0.0724948469588718 1 5.99725249459218e-06 -50.5788537427249 + 800 0.08 -0.584017381477007 -0.0766850043611196 1 6.7063419199184e-06 -50.5788693699014 + 900 0.09 -0.583812040722352 -0.0811143180675365 0.999999999999998 7.49814943594153e-06 -50.5788868434688 + 1000 0.1 -0.583582389243979 -0.0857958823565732 0.999999999999999 8.38204259112203e-06 -50.5789063784897 +Loop time of 0.229203 on 4 procs for 1000 steps with 250 atoms + +85.9% CPU use with 4 MPI tasks x no OpenMP threads + +Minimization stats: + Stopping criterion = max iterations + Energy initial, next-to-last, final = + -0.701465876911 -50.5789061722 -50.5789063785 + Force two-norm initial, final = 0 0 + Force max component initial, final = 0 0 + Final line search alpha, max atom move = 0 0 + Iterations, force evaluations = 1000 1000 + +MPI task timing breakdown: +Section | min time | avg time | max time |%varavg| %total +--------------------------------------------------------------- +Pair | 0.06774 | 0.080677 | 0.097769 | 4.4 | 35.20 +Neigh | 0 | 0 | 0 | 0.0 | 0.00 +Comm | 0.10574 | 0.11072 | 0.11498 | 1.0 | 48.31 +Output | 0.0061452 | 0.0061803 | 0.0062776 | 0.1 | 2.70 +Modify | 0.00074291 | 0.00096381 | 0.0014563 | 0.0 | 0.42 +Other | | 0.03066 | | | 13.38 + +Nlocal: 62.5 ave 65 max 60 min +Histogram: 2 0 0 0 0 0 0 0 0 2 +Nghost: 217.5 ave 240 max 195 min +Histogram: 1 1 0 0 0 0 0 0 1 1 +Neighs: 0 ave 0 max 0 min +Histogram: 4 0 0 0 0 0 0 0 0 0 +FullNghs: 800 ave 825 max 775 min +Histogram: 2 0 0 0 0 0 0 0 0 2 + +Total # of neighbors = 3200 +Ave neighs/atom = 12.8 +Neighbor list builds = 0 +Dangerous builds = 0 +Total wall time: 0:00:00 From 51743655703cbfa3e31c41894316df5f451343bb Mon Sep 17 00:00:00 2001 From: ares20105 Date: Wed, 20 Nov 2019 13:21:41 -0700 Subject: [PATCH 493/557] add force modifications. Previous code does not call force modify, thus the dynamical matrix calculation does not work for other potentials defined via modify --- src/USER-PHONON/dynamical_matrix.cpp | 7 +++++++ 1 file changed, 7 insertions(+) diff --git a/src/USER-PHONON/dynamical_matrix.cpp b/src/USER-PHONON/dynamical_matrix.cpp index 1495219124..6bb843c16e 100644 --- a/src/USER-PHONON/dynamical_matrix.cpp +++ b/src/USER-PHONON/dynamical_matrix.cpp @@ -19,6 +19,7 @@ #include "improper.h" #include "kspace.h" #include "update.h" +#include "modify.h" #include "neighbor.h" #include "pair.h" #include "timer.h" @@ -385,6 +386,7 @@ void DynamicalMatrix::displace_atom(int local_idx, int direction, int magnitude) void DynamicalMatrix::update_force() { force_clear(); + int n_post_force = modify->n_post_force; if (pair_compute_flag) { force->pair->compute(eflag,vflag); @@ -405,6 +407,11 @@ void DynamicalMatrix::update_force() comm->reverse_comm(); timer->stamp(Timer::COMM); } + + // force modifications, + if (n_post_force) modify->post_force(vflag); + timer->stamp(Timer::MODIFY); + ++ update->nsteps; } From c14ac53306d9c880f0fbaf511135d2e3b60846e5 Mon Sep 17 00:00:00 2001 From: lucienPan Date: Thu, 21 Nov 2019 12:28:18 -0500 Subject: [PATCH 494/557] Patch of class2 dihedral in OMP and Kokkos --- src/KOKKOS/dihedral_class2_kokkos.cpp | 5 +++++ src/USER-OMP/dihedral_class2_omp.cpp | 5 +++++ 2 files changed, 10 insertions(+) diff --git a/src/KOKKOS/dihedral_class2_kokkos.cpp b/src/KOKKOS/dihedral_class2_kokkos.cpp index 4b8d171f61..5f304d2620 100644 --- a/src/KOKKOS/dihedral_class2_kokkos.cpp +++ b/src/KOKKOS/dihedral_class2_kokkos.cpp @@ -253,6 +253,11 @@ void DihedralClass2Kokkos::operator()(TagDihedralClass2Compute Date: Thu, 21 Nov 2019 17:09:24 -0500 Subject: [PATCH 495/557] replace non-UTF-8 compliant character with ASCII --- src/USER-INTEL/intel_intrinsics.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/src/USER-INTEL/intel_intrinsics.h b/src/USER-INTEL/intel_intrinsics.h index 069eb5bed5..ee20cd1119 100644 --- a/src/USER-INTEL/intel_intrinsics.h +++ b/src/USER-INTEL/intel_intrinsics.h @@ -12,7 +12,7 @@ ------------------------------------------------------------------------- */ /* ---------------------------------------------------------------------- - Contributing author: Markus Hhnerbach (RWTH) + Contributing author: Markus Hoehnerbach (RWTH) ------------------------------------------------------------------------- */ // This file provides an intrinsics abstraction that allows access to the From 0085aaabd292270f8f254f0a61c65728b5440cef Mon Sep 17 00:00:00 2001 From: lucienPan Date: Thu, 21 Nov 2019 18:00:18 -0500 Subject: [PATCH 496/557] Patch of Dihedral class2 KOKKOS Since the costh12 costh13 costh13 and costh0 are declared as const, a hack using const_cast is used to work around this. --- src/KOKKOS/dihedral_class2_kokkos.cpp | 14 ++++++++++---- 1 file changed, 10 insertions(+), 4 deletions(-) diff --git a/src/KOKKOS/dihedral_class2_kokkos.cpp b/src/KOKKOS/dihedral_class2_kokkos.cpp index 5f304d2620..39be838d7e 100644 --- a/src/KOKKOS/dihedral_class2_kokkos.cpp +++ b/src/KOKKOS/dihedral_class2_kokkos.cpp @@ -253,10 +253,16 @@ void DihedralClass2Kokkos::operator()(TagDihedralClass2Compute(costh12); + F_FLOAT& ctmp13 = const_cast(costh13); + F_FLOAT& ctmp23 = const_cast(costh23); + F_FLOAT& ctmp0 = const_cast(c0); + ctmp12 = MAX(MIN(costh12, 1.0), -1.0); + ctmp13 = MAX(MIN(costh13, 1.0), -1.0); + ctmp23 = MAX(MIN(costh23, 1.0), -1.0); + ctmp0 = costh13; + } // cos and sin of 2 angles and final c From 54f998bde53e67a7ea263b04bae65275399b26b5 Mon Sep 17 00:00:00 2001 From: lucienPan Date: Thu, 21 Nov 2019 18:00:18 -0500 Subject: [PATCH 497/557] Patch of Dihedral class2 KOKKOS Since the costh12, costh13, costh23 and c0 are declared as const, a hack using const_cast is used to work around this. --- src/KOKKOS/dihedral_class2_kokkos.cpp | 14 ++++++++++---- 1 file changed, 10 insertions(+), 4 deletions(-) diff --git a/src/KOKKOS/dihedral_class2_kokkos.cpp b/src/KOKKOS/dihedral_class2_kokkos.cpp index 5f304d2620..39be838d7e 100644 --- a/src/KOKKOS/dihedral_class2_kokkos.cpp +++ b/src/KOKKOS/dihedral_class2_kokkos.cpp @@ -253,10 +253,16 @@ void DihedralClass2Kokkos::operator()(TagDihedralClass2Compute(costh12); + F_FLOAT& ctmp13 = const_cast(costh13); + F_FLOAT& ctmp23 = const_cast(costh23); + F_FLOAT& ctmp0 = const_cast(c0); + ctmp12 = MAX(MIN(costh12, 1.0), -1.0); + ctmp13 = MAX(MIN(costh13, 1.0), -1.0); + ctmp23 = MAX(MIN(costh23, 1.0), -1.0); + ctmp0 = costh13; + } // cos and sin of 2 angles and final c From 89bb2ef83fd8e22fc534fe0a7b6e71dc2e4e0484 Mon Sep 17 00:00:00 2001 From: julient31 Date: Fri, 22 Nov 2019 12:07:05 -0700 Subject: [PATCH 498/557] Commit JT 112219 - improved figure in precession/spin documentation - corrected other pair/spin interactions --- doc/src/JPG/zeeman_langevin.jpg | Bin 46268 -> 174590 bytes src/SPIN/pair_spin_dipole_cut.cpp | 2 +- src/SPIN/pair_spin_dmi.cpp | 7 +++---- src/SPIN/pair_spin_exchange.cpp | 3 ++- src/SPIN/pair_spin_magelec.cpp | 26 +++++++++++++------------- src/SPIN/pair_spin_neel.cpp | 2 +- 6 files changed, 20 insertions(+), 20 deletions(-) diff --git a/doc/src/JPG/zeeman_langevin.jpg b/doc/src/JPG/zeeman_langevin.jpg index c42c49b6c0a5c37387965c779ccbf1fa07d53959..53ce77d2a8d94d200577e8e1b0164ed238d2d483 100644 GIT binary patch literal 174590 zcmeFa1yq&G`Z&C4q`N~Jq@=qW0R<63N-1e1l}1tN?(Qx@kd%<_PLb}Emh`_t*kGJ< zJ#l|)ec!t8VL8t{J@ZaJGy6SXhrUh#P^87B!~tMnV1Opze}Jza0U`hhaPZSV-~$Q# zgMx*Ef`o*EgMopDMSw#=JLP15xz{JEvK*q+w!oWepz{EIJ z0tNw;frPpS1$7Mr5grlaFF#*D08n9}m|?OYz)%6;s9+GNU|;J1ga9xA1kl@4htD5q z7+5Gs2yn1#Kr#Uk4Sq_$AOZl8P!P~C;9#&{M*s*AKq?9Z3IG7se;vd@1o6UJZ~wXR zv&RQxriB86Ai}>5%;7>tk50ebDZxexpo|_PU5XWYM3n)o^#9TWH_`M-4yn64d2stK zZI)Ry{t$a^9NB?W^|`%GqM&V%>1TfW7ckfqU;G6O^Ldk~`XU2SXD@gGBh%~&JiN%j zxbM1rgTeL%t`i4-y&#;Xa1$NnZK~2wW09H5Umh%N83)^GcXAyZG@LVmr_qU|g9H?G zhkgk^^DHc`zM#O#lwW`VxatVPu8SOa5Cez_f;ST90uM~DlRNlqhg(r1m%&gqchZa< zk4?4fEeoD=&?;D1UBH0v)Ca$FIp+Z&qbh}dxyXPigo4b1DWj8>T@V0@DTN^TagYcI z1_BVgcmxpb)9f~bhltCztvsbm)mO=<@YM5Y$Qe8UzCY z=x3~)fT@RX6Bfz}Q|}@6Ten}Op2FZ^3@$(70KoDphhDx75FJWS25AD60|C%>tkj?k z5TIs00st)XZ!gV0hmK+4wt*w=91q*$jL=?2%ojj(>iT!l8 zrw*?0{WB1Q#L?x725?u#Y5)KOS={YfRsB-^UJiVJZ<9^a3A{Z+tMnDVe+K?gy9gDs zQu2=g02m}^zp%pB#pBcSnKp4rLX#%g{p-{L&8h#)8b}&aF;BX0pc<410`aY%PqSdH z^*pa$3}~~coj4pGAD-c^vi(i?mz4|D1;MhcUeH|7Gi%T9anBSrt!&L;t~~s&8G+WJ znD|}-hWE6Qo<7vVhu?s2|3X1)x|~5U^YbHE0>VkF>(-d#IH^z5->rpF_V$rqW&Y1F z6s7t%bs*MD%pa8)ARhxx{vwYpEo1iO)cXYP-O_AZ_J<$^zXc?>z5&3p*SHP3t(1jP z1HhU{>s`R4Le0mh(f0UfWo}7_cf}`rDW)LNP%{db-B5U@=5i`>_JF@+JcqvJ@93Tn zxUlMLbUQthOZ*Z7ye3#1V+I3j&SfTfMhVVNz+vVuJf~9xSO^c4vms2bab8S1f8lNB zNB}tAJ!lV@>bh6K2Cgu8oF#2I26svDy(8l0AC)337-@5dk_h3`b(Me-2GCvQ$GtY{lis~41P-nfM)+Wac=erh50 zU3V3z1!rl{Y`1CaV{nz~?P8aK@uF3mC>y(3a(cEg5y7?7sZ4%P{bq0Ai<&+@fG)rNbqiRyj7UpRB9Wt zVTbW(nOy9dxR11*&_&|_K*4H0ysG=VmjM6}6LZnnnTB9^IXh@xx0rSueO~ivSq+S&WDzmn-sMkzRCbfn8TH008Z$ zFhuLO6J19gWs0$ULPWn~`oqi>AI^C|m?!Q53X%R-B{6WFu4aMD#m~)- zk>%Z9E2h0fuCv%rd|c-%&YJ-LZBzh!#^oKH zI7NQn@6RxeQS(XI>*I~xgns4+4*rtqUu;|VcHB>C|LK99-2Z`vFYVzs3}~?eArME} zPkDy?wgdTI0%CHWL4V*-twpcYeALo&+0+%KtkKLs!G33~`g_j5kOPghxG#GtjaknW zeLviuD+33EFzFchsMwmiktL$g8GYbD?_9T1X8!j#L}0?$Lubm7CujK{V?0N{J79fk z|7^#1ZWWY3^Q{(@!+WUQ>$h(gDt0KQ+s41E&;}y^Rp4?kB@p)I)IE~+^9a4&oZ%<5 z&vLDWb${U3K3FflDZlBcau6IH^44UFL7<0`r$e1NBFE*gn!n%&O*Iak3Gft;C+1_w z`V=L$4`b1$ZzOrkA?08Hr6Vx&OFj#zq}b2aK0zz?xN<~wm}ypE#^|l;s2IfEuDsCx zSJMk`!2P%y!)Ib4?z_NY#1dN+v0f7nnOtLFZe!kH1FT`W{6g;urjOpnz5ex3$Yb%z z;(1MkF+-mQ0WIV#vilvsVE>OOa3tYs+PkV}e9)R~VE(cWx|WInxVp($*P+{zxHCL6 z2vyQ&+w`AxfgN4%vWaM0RYl*e;2;W%^0S0L+(@#0`D5?@S@KsHP_4YY4rBG!)1iL? z;>%-^&-y*#46YnRccq9D&o6ljbf z=zVR6e2w)?;_7PqI~BacPTEeBDtXUxLQI%PvWp4^@M7P#*R!OA;(W*Vn;B3?1q*M- zxRdJr=f)w~x3HWRZyt2L*B^Vtk$~SXBHxwOa{QtFZ4cctJ=yB=-|+!de(-Qw5gEex zQx|?*T%5Ue{tq!@>@s)zhzi4tTa=+(Yo>-P!Td7g?(ia^s!9syBY3+_fJ#M`23CQPmKav- zx35f>Rc_2L5^VCtiq&-H@C+}x{Hcjw5JA;_PScy};UN$I1>-jq>};HO!q9R`@Gx0u zEE@;%P)56by2Z_*2UvD&QIC^d1c)m61)TX^{!qa$2w)9l6v77Ib=k+lW873ve!=?< z1@`4|%SWKoqG|~E_NSRlXDt>UzOjk(i}oLjO76!`)@C?+-v`p=P$i_pkj!v9Upri zz2?c#s&NhT_wzypthD9Az2f0*g97n?#qj0i_)Y3Rl^1}qwvHDvHuV+2pJ!^%V4kF@ z#1>W8Vp_}-li84@E}4Ayi1Hs0Kf5bWyncg8kR1AEK7OT9N%E2nF$;O3^7>nwTrrt)QXU z#7uU1q|j5A^C!kXLR<~4w6Nf=v!TGax9Mg4*-!^k1X zmeVm`I(IDNZ&Y^t!J0>D=g@B=V4i1t$e~%o3YjB*pcn~M>{xPwx}L&8b7O!b5x|VP4!YLZ}V)aX7~>o?T?o(Mj?Bs000E=#3;*c zN&}p0wa6TJuB0n{{?R5YUDF6P)gm{)c0ag?Hty(ERR>mvoDR!Rk`6hxWWNv5fxGJ~2%es3 zZdsq7s47LNnP{tY&RJSlJnv$#l3)w@w5K`HuDN|U0h~1=c=8ALEgd%X_OrgMx&c@6 z0I<%W`5Ll$;JN`g`uz|A|KWbZxmy^+7FQiSho7~yz54~4R!hyM8UVP5?`>CZ;%B&o zM$acK2mtf84>7HpQi{zZVyY6VEZrv>Y^>FOsBCz5@gRmpwui)jS5Cc>Aw(f`H2hEEW;zG6#Y#4kkc| zGhhSLz|7@))M-u$vT5xb8XWP>qYg)I;`#N~y%?E-BDDzs&Fb6r8w$HUPIouoarQT1)E~F zJz_KO;!IT$NcE?fJG}sM{(z~WTgG2xzPoL54=NXg|Ngp7a*@jg<@@V4>GV$=jvZR~ zJgZ`;=3B?x)fBz!J}v`<%tqQxde%Och4P#@!pPmbKx{ZwSDykj10DZ0RjZ5{C8b0 zazqeg7a+hEx%6@i#S2q$PC#zn2khe^T(Cho2;CN< zq(zk%9o(-S=o9OIHUPyg1P@y*_!9wcG?vJfI}m*BCkoiT&;)F1;6a7|Poy+SRL58a zFGe)2E2QSR1m@>?E>|$$K(G*52D{sLe!{~F`N$3^CcEdrcLn|=MYF{jRg%!$%*g$d z95PdAyRa_HrV$w>-uaQiDGyjc`xBj@2gLC|2|y5_iNqWHT=@`8kvJWc{